TDDFPT/0000755000175000017500000000000012364233344010127 5ustar mbambaTDDFPT/tools/0000755000175000017500000000000012341371517011267 5ustar mbambaTDDFPT/tools/tddfpt_calculate_spectrum.f900000755000175000017500000010010012341371472017026 0ustar mbamba!----------------------------------------------------------------------- PROGRAM lr_calculate_spectrum !--------------------------------------------------------------------- ! ... calculates the spectrum ! ... by solving tridiagonal problem for each value of omega !--------------------------------------------------------------------- ! USE kinds, ONLY : dp USE constants, ONLY : pi,rytoev,evtonm,rytonm USE io_files, ONLY : tmp_dir, prefix,nd_nmbr USE global_version, ONLY : version_number USE io_global, ONLY : stdout,ionode, ionode_id USE environment, ONLY: environment_start,environment_end USE mp_global, ONLY : mp_startup,mp_global_end USE mp_world, ONLY : world_comm USE mp, ONLY : mp_bcast, mp_barrier IMPLICIT NONE ! CHARACTER(len=256), EXTERNAL :: trimcheck ! !Constants ! ! integer, parameter :: dp=kind(0.d0) ! real(dp), parameter :: pi=3.14159265d0 ! real(dp), parameter :: ry=13.6056981d0 ! real(dp), parameter :: ev2nm=1239.84172 ! real(dp), parameter :: ry2nm=91.1266519 ! !User controlled variables ! real(dp) :: omega(3) INTEGER :: ipol INTEGER :: itermax, itermax0, itermax_actual INTEGER :: sym_op INTEGER :: verbosity real(kind=dp) :: start,end,increment real(kind=dp) :: omegmax,delta_omeg CHARACTER(len=60) :: extrapolation,td CHARACTER(len=256) :: outdir, filename,eign_file INTEGER :: units ! !General use variables & counters ! INTEGER :: n_ipol real(dp), ALLOCATABLE, DIMENSION(:,:) :: beta_store, gamma_store COMPLEX(dp), ALLOCATABLE, DIMENSION(:,:,:) :: zeta_store real(dp) :: norm0(3) INTEGER :: i,j, info, ip, ip2, counter real(kind=dp) :: average(3), av_amplitude(3), epsil INTEGER :: ios real (kind=dp) :: alpha_temp(3),scale,wl real (kind=dp) :: f_sum COMPLEX(kind=dp) :: omeg_c COMPLEX(kind=dp) :: green(3,3), eps(3,3) COMPLEX(kind=dp), ALLOCATABLE :: a(:), b(:), c(:), r(:,:) LOGICAL :: skip, exst real(kind=dp) :: omeg, z1,z2 real(DP) :: degspin ! ! !For perceived color analysis ! real(dp),PARAMETER :: vis_start=0.116829041,vis_start_wl=780 real(dp),PARAMETER :: vis_end=0.239806979,vis_end_wl=380 real(dp) :: perceived_red=0.0d0,perceived_green=0.0d0,perceived_blue=0.0d0 real(dp) :: perceived_renorm INTEGER :: perceived_itermax,perceived_iter real(dp), ALLOCATABLE :: perceived_intensity(:) real(dp), ALLOCATABLE :: perceived_evaluated(:) LOGICAL :: do_perceived ! !Subroutines etc. ! COMPLEX(kind=dp), EXTERNAL :: zdotc CHARACTER(len=6), EXTERNAL :: int_to_char ! !DEBUGGING real(kind=dp) :: test ! !User controlled variable initialisation ! NAMELIST / lr_input / itermax, itermax0, itermax_actual, extrapolation,& & end, increment, start, ipol, outdir, prefix,& & epsil, sym_op, verbosity, units,omeg,omegmax,& & delta_omeg, td,eign_file ! !Initialization of system variables ! !for the time being, degspin is set by hand degspin=2.d0 ! prefix = 'pwscf' outdir = './' itermax=1000 itermax0=1000 !itermax_actual=1000 extrapolation="no" end=2.50d0 increment=0.001d0 start=0.0d0 epsil=0.02 ipol=1 sym_op=0 verbosity=0 units=0 omeg=-1 delta_omeg=-1 omegmax=-1 td='lanczos' ! !Other initialisation ! f_sum=0.0d0 ! !DEBUG test=0.0d0 ! #ifdef __MPI CALL mp_startup ( ) IF (ionode) THEN WRITE(*,*) "Warning: Only a single cpu will be used!" ENDIF #endif CALL environment_start ( 'TDDFPT_PP' ) ! The code starts here ios=0 IF (ionode) THEN ! No need for parallelization in this code CALL input_from_file() READ (5, lr_input, iostat = ios) ENDIF CALL mp_bcast ( ios, ionode_id , world_comm ) CALL errore ('lr_readin', 'reading lr_input namelist', abs (ios) ) if(trim(td)=="davidson" .or. trim(td)=='david') then if(ionode) call spectrum_david() goto 555 endif IF (ionode) THEN IF (itermax0 < 151 .and. trim(extrapolation)/="no") THEN WRITE(*,*) "Itermax0 is less than 150, no extrapolation scheme can be used!" extrapolation="no" ENDIF outdir = trimcheck(outdir) tmp_dir = outdir IF (ipol < 4) THEN n_ipol=1 ELSE n_ipol=3 ipol = 1 ENDIF ! Polarization symmetry IF ( .not. sym_op == 0 ) THEN ! CALL errore("tddfpt_pp","Unsupported symmetry operation",1) IF (sym_op == 1) THEN WRITE(stdout,'(5x,"All polarization axes will be considered to be equal.")') n_ipol=3 ipol=1 ELSE CALL errore("tddfpt_pp","Unsupported symmetry operation",1) ENDIF ENDIF ! Terminator Scheme IF (trim(extrapolation)=="no") THEN ! itermax=itermax0 ! ENDIF ! !Check the unit system used ! IF (units < 0 .or. units >2) THEN CALL errore("tddfpt_pp","Unsupported unit system",1) ENDIF IF ( units /= 0 .and. verbosity > 4) THEN WRITE(stdout,'(5x,"Verbosity this high is not supported when non-default units are used")') verbosity=4 ENDIF ! IF (omeg>0 .or. omegmax>0 .or. delta_omeg>0) THEN WRITE(stdout,'(5x,"Warning, omeg, omegmax and delta_omeg depreciated, use start,end,increment instead")') start=omeg end=omegmax increment=delta_omeg units = 0 ENDIF ! !Initialisation of coefficients ! ALLOCATE(beta_store(n_ipol,itermax)) ALLOCATE(gamma_store(n_ipol,itermax)) ALLOCATE(zeta_store(n_ipol,n_ipol,itermax)) ! !beta_store=0.d0 !gamma_store=0.d0 !zeta_store=(0.d0,0.d0) ! ALLOCATE(a(itermax)) ALLOCATE(b(itermax-1)) ALLOCATE(c(itermax-1)) ALLOCATE(r(n_ipol,itermax)) ! a(:) = (0.0d0,0.0d0) b(:) = (0.0d0,0.0d0) c(:) = (0.0d0,0.0d0) r(:,:) = (0.0d0,0.0d0) !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! CALL read_b_g_z_file() !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! CALL extrapolate() !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! ! ! ! Spectrum calculation ! ! WRITE (stdout,'(/5x,"Data ready, starting to calculate observables")') WRITE (stdout,'(/5x,"Broadening = ",f15.8," Ry")') epsil filename = trim(prefix) // ".plot" WRITE (stdout,'(/5x,"Output file name: ",A20)') filename WRITE(stdout,'(/,5x,"chi_i_j: dipole polarizability tensor in units of e^2*a_0^2/energy")') IF (n_ipol == 3) THEN WRITE(stdout,'(/,5x,"S: oscillator strength in units of 1/energy")') WRITE(stdout,'(/,5x,"S(\hbar \omega) = 2m/( 3 \pi e^2 \hbar) \omega sum_j chi_j_j")') WRITE(stdout,'(/,5x,"S(\hbar \omega) satisfies the f-sum rule: \int_0^\infty dE S(E) = N_el ")') ELSE WRITE (stdout,'(/,5x,"Insufficent info for S")') ENDIF IF (units == 0) THEN WRITE (stdout,'(/,5x,"Functions are reported in \hbar.\omega Energy unit is (Ry)")') ELSEIF (units == 1) THEN WRITE (stdout,'(/,5x,"Functions are reported in \hbar.\omega Energy unit is (eV)")') ELSEIF (units == 2) THEN WRITE (stdout,'(/,5x,"Functions are reported in (nm), Energy unit is (eV) ")') ENDIF ! ! The static polarizability ! IF (verbosity>0) THEN WRITE (stdout,'(/,5x,"Static dipole polarizability Tensor:")') CALL calc_chi(0.0d0,epsil,green(:,:)) DO ip=1,n_ipol ! DO ip2=1,n_ipol ! IF(n_ipol == 3) WRITE(stdout,'(5x,"chi_",i1,"_",i1,"=",2x,e21.15," + i",e21.15)') & ip2, ip, dble(green(ip,ip2)), aimag(green(ip,ip2)) ! IF(n_ipol == 1) WRITE(stdout,'(5x,"chi_",i1,"_",i1,"=",2x,e21.15," + i",e21.15)') & ipol, ipol, dble(green(ip,ip2)), aimag(green(ip,ip2)) ! ENDDO ! ENDDO ENDIF !!!! The output file: OPEN(17,file=filename,status="unknown") ! The perceived color analysis uses the perception fit from the following program: ! RGB VALUES FOR VISIBLE WAVELENGTHS by Dan Bruton (astro@tamu.edu) ! ! ! Lets see if the environment is suitable for perceived color analysis ! do_perceived=.false. IF (verbosity > 2) THEN IF (units == 0 .and. startvis_end .and. n_ipol == 3) THEN WRITE (stdout,'(/,5x,"Will attempt to calculate perceived color")') do_perceived=.true. perceived_iter=1 perceived_itermax=int((vis_end-vis_start)/increment) ALLOCATE(perceived_intensity(perceived_itermax)) ALLOCATE(perceived_evaluated(perceived_itermax)) perceived_intensity(:)=0.0d0 perceived_evaluated(:)=-1.0d0 perceived_renorm=-9999999.0d0 ELSEIF (units == 2 .and. startvis_start_wl .and. n_ipol == 3) THEN WRITE (stdout,'(/,5x,"Will attempt to calculate perceived color")') do_perceived=.true. perceived_iter=1 perceived_itermax=int((vis_start_wl-vis_end_wl)/increment) ALLOCATE(perceived_intensity(perceived_itermax)) ALLOCATE(perceived_evaluated(perceived_itermax)) perceived_intensity(:)=0.0d0 perceived_evaluated(:)=-1.0d0 perceived_renorm=-9999999.0d0 ELSEIF (verbosity>2) THEN WRITE (stdout,'(/,5x,"Will not calculate perceived color")') do_perceived=.false. ENDIF ENDIF ! ! Header of the output plot file ! IF (units == 0) THEN WRITE (17,'("#Chi is reported as CHI_(i)_(j) \hbar \omega (Ry) Re(chi) (e^2*a_0^2/Ry) Im(chi) (e^2*a_0^2/Ry) ")') ELSEIF (units == 1) THEN WRITE (17,'("#Chi is reported as CHI_(i)_(j) \hbar \omega (eV) Re(chi) (e^2*a_0^2/eV) Im(chi) (e^2*a_0^2/eV) ")') ELSEIF (units == 2) THEN WRITE (17,'("#Chi is reported as CHI_(i)_(j) wavelength (nm) Re(chi) (e^2*a_0^2/eV) Im(chi) (e^2*a_0^2/eV) ")') ENDIF IF (n_ipol == 3) THEN WRITE(17,'("# S(E) satisfies the sum rule ")' ) ENDIF ! ! Start the omega loop ! !Units conversion and omega history omega(1)=omega(2) omega(2)=omega(3) IF (units == 0) THEN omega(3)=start ELSEIF (units == 1) THEN omega(3)=start/rytoev ELSEIF (units == 2) THEN omega(3)=rytonm/start ENDIF ! !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!FIRST STEP!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! IF (verbosity > 0 .and. n_ipol == 3) THEN ! In order to gain speed, I perform first term separately ! CALL calc_chi(omega(3),epsil,green(:,:)) IF (units == 1 .or. units == 2) THEN green(:,:)=green(:,:)/rytoev ENDIF DO ip=1,n_ipol ! DO ip2=1,n_ipol ! !eps(ip,ip2)=(1.d0,0.d0)-(32.d0*pi/omega)*green(ip,ip2) ! WRITE(17,'(5x,"chi_",i1,"_",i1,"=",2x,3(e21.15,2x))') & ip2, ip, start, dble(green(ip,ip2)), aimag(green(ip,ip2)) ! write(*,'(5x,"eps_",i1,"_",i1,"=",2x,3(e21.15,2x))') & ! ip2, ip, ry*omeg, dble(eps), aimag(eps) ! ENDDO ! ENDDO alpha_temp(3)= omega(3)*aimag(green(1,1)+green(2,2)+green(3,3))/(pi*3.d0) IF (units == 1 .or. units == 2) THEN alpha_temp(3)=alpha_temp(3)*rytoev ENDIF !alpha is ready WRITE(17,'(5x,"S(E)=",2x,2(e21.15,2x))') & start, alpha_temp(3) f_sum=0.3333333333333333d0*increment*alpha_temp(3) start=start+increment ENDIF !!!!!!!!!!!!!!!!!!OMEGA LOOP!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! DO WHILE(start700) THEN scale=.3+.7* (780.-wl)/(780.-700.) ELSEIF (wl<420.) THEN scale=.3+.7*(wl-380.)/(420.-380.) ELSE scale=1. ENDIF alpha_temp(:)=scale*alpha_temp(:) !Then the data from absorbtion spectrum alpha_temp(:)=perceived_intensity(i)*alpha_temp(:) !The perceived color can also be calculated here IF (j==1) THEN perceived_red=perceived_red+alpha_temp(1) perceived_green=perceived_green+alpha_temp(2) perceived_blue=perceived_blue+alpha_temp(3) ENDIF IF (alpha_temp(1)>1.0d0) PRINT *,alpha_temp(1) WRITE(20, '(3A1)', advance='no') achar(int(255*alpha_temp(1))), & achar(int(255*alpha_temp(2))), & achar(int(255*alpha_temp(3))) ENDIF ENDDO ENDDO CLOSE(20) !Now lets write a file with perceived color perceived_red=perceived_red/(1.0d0*perceived_itermax) perceived_green=perceived_green/(1.0d0*perceived_itermax) perceived_blue=perceived_blue/(1.0d0*perceived_itermax) WRITE(stdout,'(5x,"Perceived R G B ",3(F15.8,1X))') perceived_red,perceived_green,perceived_blue filename = trim(prefix) // "-perceived.ppm" OPEN(UNIT=20,FILE=filename,STATUS='UNKNOWN') WRITE(20, '(A2)') 'P6' WRITE(20, '(I0,'' '',I0)') 180,180 WRITE(20, '(A)') '255' DO j=1, 180 DO i=1, 180 WRITE(20, '(3A1)', advance='no') achar(int(255*perceived_red)), & achar(int(255*perceived_green)), & achar(int(255*perceived_blue)) ENDDO ENDDO CLOSE(20) ENDIF !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! IF (verbosity > 9) THEN start=0.0 f_sum=0.0 DO WHILE (start itermax_actual .or. itermax0 > itermax) THEN CALL errore("tddfpt_calculate_spectrum", "Error in Itermax0",1) ENDIF ! READ(158,*) norm0(ip) !print *, "norm0(", ip,")=",norm0(ip) ! DO i=1,itermax0 ! READ(158,*) beta_store(ip,i) READ(158,*) gamma_store(ip,i) READ(158,*) zeta_store (ip,:,i) ! ! print *, "ip=",ip,"i=",i,"beta_store=",beta_store(ip,i),"gamma_store=",gamma_store(ip,i),"zeta_store=",zeta_store (ip,:,i) ENDDO ! CLOSE(158) beta_store(ip,itermax0+1:)=0.d0 gamma_store(ip,itermax0+1:)=0.d0 zeta_store(ip,:,itermax0+1:)=(0.d0,0.d0) ENDDO ELSEIF (sym_op==1) THEN filename = trim(prefix) // ".beta_gamma_z." // trim(int_to_char(ipol)) filename = trim(tmp_dir) // trim(filename) ! INQUIRE (file = filename, exist = exst) ! IF (.not.exst) THEN ! CALL errore("tddfpt_calculate_spectrum", "Error reading file",1) !WRITE( *,*) "ERROR: " // trim(filename) // " does not exist" !stop ! ENDIF ! OPEN (158, file = filename, form = 'formatted', status = 'old') ! READ(158,*) itermax_actual WRITE(stdout,'(/5X,"Reading ",I6," Lanczos steps for direction ",I1)') itermax_actual, ipol WRITE(stdout,'(5X,I6," steps will be considered")') itermax0 IF (itermax0 > itermax_actual .or. itermax0 > itermax) THEN CALL errore("tddfpt_calculate_spectrum", "Error in Itermax0",1) ENDIF ! READ(158,*) norm0(1) !print *, "norm0(", ip,")=",norm0(ip) ! norm0(2)=norm0(1) norm0(3)=norm0(1) DO i=1,itermax0 ! READ(158,*) beta_store(1,i) beta_store(2,i)=beta_store(1,i) beta_store(3,i)=beta_store(1,i) READ(158,*) gamma_store(1,i) gamma_store(2,i)=gamma_store(1,i) gamma_store(3,i)=gamma_store(1,i) READ(158,*) zeta_store (1,1,i) zeta_store (2,2,i)=zeta_store (1,1,i) zeta_store (3,3,i)=zeta_store (1,1,i) zeta_store (1,2,i)=(0.0d0,0.0d0) zeta_store (1,3,i)=(0.0d0,0.0d0) zeta_store (2,1,i)=(0.0d0,0.0d0) zeta_store (2,3,i)=(0.0d0,0.0d0) zeta_store (3,1,i)=(0.0d0,0.0d0) zeta_store (3,2,i)=(0.0d0,0.0d0) ! ENDDO ! CLOSE(158) beta_store(:,itermax0+1:)=0.d0 gamma_store(:,itermax0+1:)=0.d0 zeta_store(:,:,itermax0+1:)=(0.d0,0.d0) ENDIF END SUBROUTINE read_b_g_z_file !------------------------------------------------ SUBROUTINE extrapolate() ! !This subroutine applies the "extrapolation" scheme for extrapolating the reduced matrix ! IMPLICIT NONE ! ! ! Terminatore ! ! skip=.false. IF (trim(extrapolation)/="no") THEN ! average=0.d0 av_amplitude=0.d0 ! DO ip=1,n_ipol ! WRITE(stdout,'(/5x,"Polarization direction:",I1)') ip counter=0 ! DO i=151,itermax0 ! IF (skip .eqv. .true.) THEN skip=.false. CYCLE ENDIF ! IF (mod(i,2)==1) THEN ! IF ( i/=151 .and. abs( beta_store(ip,i)-average(ip)/counter ) > 2.d0 ) THEN ! !if ( i.ne.151 .and. counter == 0) counter = 1 skip=.true. ! ELSE ! average(ip)=average(ip)+beta_store(ip,i) av_amplitude(ip)=av_amplitude(ip)+beta_store(ip,i) counter=counter+1 !print *, "t1 ipol",ip,"av_amp",av_amplitude(ip) ! ENDIF ! ELSE ! IF ( i/=151 .and. abs( beta_store(ip,i)-average(ip)/counter ) > 2.d0 ) THEN ! !if ( i.ne.151 .and. counter == 0) counter = 1 skip=.true. ! ELSE ! average(ip)=average(ip)+beta_store(ip,i) av_amplitude(ip)=av_amplitude(ip)-beta_store(ip,i) counter=counter+1 !print *, "t2 ipol",ip,"av_amp",av_amplitude(ip) ! ENDIF ! ENDIF ! ENDDO ! average(ip)=average(ip)/counter av_amplitude(ip)=av_amplitude(ip)/counter !print *, "t3 ipol",ip,"av_amp",av_amplitude(ip) ! WRITE(stdout,'(5x,"Average =",3F15.8)') average(ip) WRITE(stdout,'(5x,"Average oscillation amplitude =",F15.8)') av_amplitude(ip) ENDDO ! IF (trim(extrapolation)=="constant") av_amplitude=0 ! ! DO ip=1,n_ipol ! DO i=itermax0,itermax ! IF (mod(i,2)==1) THEN ! beta_store(ip,i)=average(ip)+av_amplitude(ip) gamma_store(ip,i)=average(ip)+av_amplitude(ip) ! ELSE ! beta_store(ip,i)=average(ip)-av_amplitude(ip) gamma_store(ip,i)=average(ip)-av_amplitude(ip) ! ENDIF ! ENDDO ! ENDDO ! ENDIF ! IF (verbosity > -1) THEN ! Write all the coefficients in a file for detailed post-processing DO ip=1,n_ipol IF (n_ipol==3) filename = trim(prefix) // ".beta_term." // trim(int_to_char(ip)) IF (n_ipol==1) filename = trim(prefix) // ".beta_term." // trim(int_to_char(ipol)) filename = trim(tmp_dir) // trim(filename) ! OPEN (17, file = filename, status = 'unknown') ! DO i=1,itermax ! WRITE(17,'(i5,2x,e21.15)') i,beta_store(ip,i) ! ENDDO ! CLOSE(17) ENDDO ENDIF END SUBROUTINE extrapolate !------------------------------------------------ SUBROUTINE calc_chi(freq,broad,chi) ! Calculates the susceptibility, IMPLICIT NONE real(kind=dp), INTENT(in) :: freq real(kind=dp), INTENT(in) :: broad COMPLEX(kind=dp), INTENT(out) :: chi(:,:) omeg_c = cmplx(freq,broad,dp) ! DO ip=1, n_ipol ! a(:) = omeg_c ! DO i=1,itermax-1 ! b(i)=cmplx(-beta_store(ip,i),0.0d0,dp) c(i)=cmplx(-gamma_store(ip,i),0.0d0,dp) ! ENDDO ! r(ip,:) =cmplx(0.0d0,0.0d0,dp) r(ip,1)=cmplx(1.0d0,0.0d0,dp) ! CALL zgtsv(itermax,1,b,a,c,r(ip,:),itermax,info) !|w_t|=(w-L) |1,0,0,...,0| IF(info /= 0) & CALL errore("tddfpt_pp", "Unable to solve tridiagonal system",1) !p=-div.rho' !p= chi . E ! Thus !chi = - ! Notice that brodening has a positive sign, thus the abs. coefficient is Im(tr(chi)) not -Im(Tr(chi)) as usual DO ip2=1,n_ipol chi(ip,ip2)=zdotc(itermax,zeta_store(ip,ip2,:),1,r(ip,:),1) chi(ip,ip2)=chi(ip,ip2)*cmplx(norm0(ip),0.0d0,dp) ! The response charge density is defined as 2.*evc0*q, see Eq. (43) in JCP 128, 154105 (2008). The dipole is therefore ! given by 2.*degspin* zeta^T * (w-T^itermax)^-1 * e_1. See also Eq. (15) in that paper. ! the minus sign accounts for the negative electron charge (perturbation is -e E x, rather than E x) chi(ip,ip2)=chi(ip,ip2)*cmplx(-2.d0*degspin, 0.d0, dp) ENDDO ENDDO END SUBROUTINE calc_chi !------------------------------------------------ SUBROUTINE wl_to_color(wavelength,red,green,blue) ! Gives the colour intensity of a given wavelength in terms of red green and blue IMPLICIT NONE real(kind=dp), INTENT(in) :: wavelength real(kind=dp), INTENT(out) :: red,green,blue IF ((wavelength>=380.).and.(wavelength<=440.)) THEN red = -1.*(wavelength-440.)/(440.-380.) green = 0. blue = 1. ENDIF IF ((wavelength>=440.).and.(wavelength<=490.)) THEN red = 0. green = (wavelength-440.)/(490.-440.) blue = 1. ENDIF IF ((wavelength>=490.).and.(wavelength<=510.)) THEN red = 0. green = 1. blue = -1.*(wavelength-510.)/(510.-490.) ENDIF IF ((wavelength>=510.).and.(wavelength<=580.)) THEN red = (wavelength-510.)/(580.-510.) green = 1. blue = 0. ENDIF IF ((wavelength>=580.).and.(wavelength<=645.)) THEN red = 1. green = -1.*(wavelength-645.)/(645.-580.) blue = 0. ENDIF IF ((wavelength>=645.).and.(wavelength<=780.)) THEN red = 1. green = 0. blue = 0. ENDIF END SUBROUTINE wl_to_color subroutine spectrum_david() implicit none real(dp) :: energy,chi(4) integer :: ieign, nstep, istep real(dp) :: frequency, temp real(dp), allocatable :: absorption(:,:) open(18,file=trim(eign_file),action='read') nstep=(end-start)/increment+1 allocate(absorption(nstep,5)) ! Column 1: Energy; 2: Toal; 3,4,5: X,Y,Z absorption(:,:)=0.0d0 read(18,*) ! Jump to the second line 522 read(18,*,END=521) energy,chi frequency=start istep=1 do while( .not. istep .gt. nstep ) absorption(istep,1)=frequency temp=frequency-energy temp=epsil/(temp**2+epsil**2) absorption(istep,2)=absorption(istep,2)+chi(1)*temp absorption(istep,3)=absorption(istep,3)+chi(2)*temp absorption(istep,4)=absorption(istep,4)+chi(3)*temp absorption(istep,5)=absorption(istep,5)+chi(4)*temp istep=istep+1 frequency=frequency+increment enddo goto 522 521 close(18) filename=trim(prefix)//".plot" OPEN(17,file=filename,status="unknown") write(17,'("#",2x,"Energy(Ry)",10x,"total",13x,"X",13x,"Y",13x,"Z")') write(17,'("# Broadening is: ",5x,F10.7,5x,"Ry")') epsil istep=1 do while( .not. istep .gt. nstep ) write(17,'(5E20.8)') absorption(istep,1),absorption(istep,1)*absorption(istep,2),& absorption(istep,1)*absorption(istep,3),absorption(istep,1)*& absorption(istep,4),absorption(istep,1)*absorption(istep,5) istep=istep+1 enddo print *, " The spectrum is in file: ", filename close(17) return end subroutine spectrum_david !------------------------------------------------ END PROGRAM lr_calculate_spectrum !----------------------------------------------------------------------- TDDFPT/tools/tddfpt_regen_bgz.tcl0000755000175000017500000001256712341371472015320 0ustar mbamba#!/bin/sh # the next line restarts using tclsh \ exec tclsh "$0" "$@" proc ::main {argc argv} { global beta_gamma_z_file global pw_output_file get_commandline $argc $argv extract_beta_gamma_z } ########################## #A procedure to read commandline ########################## proc ::get_commandline {argc argv} { global pw_output_file global beta_gamma_z_file if { $argc < 1} { puts stderr "Usage: tddfpt_regen_bgz.tcl \[parameters\]" puts stderr "Parameters:" puts stderr "none at the moment " exit 1 } if { $argc > 0 } { set state first foreach arg $argv { switch -- $state { first { set state flag #check if the infile exists set pw_output_file $arg if { [file exists $pw_output_file] } { puts "using output file $pw_output_file" } else { puts stderr "File $pw_output_file does not exits" exit 1 } } flag { switch -glob -- $arg { default { puts stderr "unknown flag $arg" exit 2 } } } } } } set beta_gamma_z_file "$pw_output_file.beta_gamma_z" } ########################## #Decides where to put the output ########################## proc ::extract_beta_gamma_z {} { global beta_gamma_z_file global pw_output_file global n_step global n_loop global lc_pos global lanc_norm global z1 #read the output file into memory if [catch {open $pw_output_file r} fileId] { puts stderr "Cannot open $pw_output_file: $fileId" exit 1 } set tmpfile [read $fileId] close $fileId #find the number of iterations if {![regexp -linestop -- {Number of Lanczos iterations =\s*([0-9]+)} $tmpfile match n_step]} { puts "Error reading Number of Lanczos steps performed, exiting" exit 2 } puts "The number of Lanczos steps for each loop : $n_step" #find number of loops if {![regexp -all -- {.*tarting Lanczos loop\s+([1-3])} $tmpfile match n_loop ]} { puts "Error reading Number of Lanczos loops performed, exiting" exit 2 } puts "Number of loops : $n_loop" incr n_loop 1 #loop over polarization directions set lc_pos 0 for {set current_loop 1} {$current_loop<$n_loop} {incr current_loop} { #find the initial norm of vectors if {![regexp -start $lc_pos -- {Norm of initial Lanczos vectors=\s+([0-9]+\.[0-9]+)} $tmpfile match lanc_norm ]} { puts "Error reading Norm for loop $current_loop" exit 2 } puts "Norm for loop $current_loop : $lanc_norm" #open the file and put the preliminaries if [catch {open $beta_gamma_z_file.$current_loop w} fileId] { puts stderr "Cannot open $beta_gamma_z_file.$current_loop: $fileId" exit 1 } puts $fileId [format "%12i" $n_step] puts $fileId [format "%19.14f" $lanc_norm] #locate the current loop if {![regexp -indices -start $lc_pos -linestop -- {tarting Lanczos loop\s+[1-3]} $tmpfile match]} { puts "Error locating loop $current_loop" exit 2 } set lc_pos [lindex [split $match] 1] #start reading the indices for {set current_step 1} {$current_step<=$n_step} {incr current_step} { if {![regexp -indices -start $lc_pos -linestop -- "Lanczos iteration:\\s*$current_step" $tmpfile match]} { puts "Error locating step $current_step in loop $current_loop" exit 2 } set lc_pos [lindex [split $match] 1] #puts "Step no $current_step at $lc_pos" #read beta if {![regexp -start $lc_pos -linestop -- {beta.*=(-?[0-9]*\.[0-9]+E[-+]?[0-9]+)} $tmpfile match beta]} { puts "Error locating beta in step $current_step, loop $current_loop" exit 2 } puts $fileId [format "%19.14f" $beta] #read gamma if {![regexp -start $lc_pos -linestop -- {gamma.*=(-?[0-9]*\.[0-9]+E[-+]?[0-9]+)} $tmpfile match gamma]} { puts "Error locating beta in step $current_step, loop $current_loop" exit 2 } puts $fileId [format "%19.14f" $gamma] #read zeta for {set i 1} {$i<$n_loop} {incr i} { if {![regexp -start $lc_pos -linestop -- "z1=\\s+$i\\s+(-?\[0-9\]*\\.\[0-9\]+E\[-+\]?\[0-9\]+)\\s+(-?\[0-9\]*\\.\[0-9\]+E\[-+\]?\[0-9\]+)" $tmpfile match z1i z1r]} { puts "Error locating z1_$i in step $current_step, loop $current_loop" exit 2 } set z1i [format "%21.15E" $z1i] regsub -- {(E[+-])} $z1i {\10} z1i set z1r [format "%21.15E" $z1r] regsub -- {(E[+-])} $z1r {\10} z1r puts $fileId " ($z1i,$z1r)" } } close $fileId } } main $argc $argv TDDFPT/tools/Makefile0000644000175000017500000000147212341371472012733 0ustar mbamba# Makefile for TDDFPT tools include ../../make.sys IFLAGS = -I../../include LIBOBJS = ../../flib/ptools.a ../../flib/flib.a ../../clib/clib.a ../../iotk/src/libiotk.a # location of needed modules MODFLAGS= $(MOD_FLAG)../../iotk/src $(MOD_FLAG)../../Modules $(MOD_FLAG). QEMODS = ../../Modules/libqemod.a PWOBJS = ../../PW/src/libpw.a TLDEPS=bindir libs pw all : tldeps turbo_spectrum.x turbo_spectrum.x : tddfpt_calculate_spectrum.o $(QEMODS) $(LD) $(LDFLAGS) -o $@ \ tddfpt_calculate_spectrum.o $(QEMODS) $(PWOBJS) $(LIBOBJS) $(LIBS) - ( cd ../../bin ; ln -fs ../TDDFPT/tools/$@ . ) - if [ -d ../bin ] ; then ( cd ../bin ; ln -fs ../tools/$@ . ); fi tldeps : if test -n "$(TLDEPS)" ; then \ ( cd ../.. ; $(MAKE) $(TLDEPS) || exit 1 ) ; fi clean : rm -f ../bin/turbo_spectrum.x *.x *.o *.mod TDDFPT/Examples/0000755000175000017500000000000012341371517011705 5ustar mbambaTDDFPT/Examples/CH4-PBE0/0000755000175000017500000000000012341371517012747 5ustar mbambaTDDFPT/Examples/CH4-PBE0/CH4.tddfpt-in0000644000175000017500000000017012341371500015126 0ustar mbamba&lr_input prefix="ch4", outdir='./out', restart_step=250, / &lr_control itermax=500, ipol=4 / TDDFPT/Examples/CH4-PBE0/CH4.tddfpt_pp-ref0000644000175000017500000000356212341371500016003 0ustar mbamba Warning: Only a single cpu will be used! Program TDDFPT_PP v.4.99 starts on 31Jan2012 at 19:18:50 This program is part of the open-source Quantum ESPRESSO suite for quantum simulation of materials; please cite "P. Giannozzi et al., J. Phys.:Condens. Matter 21 395502 (2009); URL http://www.quantum-espresso.org", in publications or presentations arising from this work. More details at http://www.quantum-espresso.org/quote.php Parallel version (MPI), running on 1 processors Reading 500 Lanczos steps for direction 1 450 steps will be considered Reading 500 Lanczos steps for direction 2 450 steps will be considered Reading 500 Lanczos steps for direction 3 450 steps will be considered Polarization direction:1 Average = 13.03077238 Average oscillation amplitude = 0.41232952 Polarization direction:2 Average = 13.02976687 Average oscillation amplitude = 0.41229057 Polarization direction:3 Average = 13.03087114 Average oscillation amplitude = 0.41231084 Data ready, starting to calculate observables Broadening = 0.01000000 Ry Output file name: ch4.plot chi_i_j: dipole polarizability tensor in units of e^2*a_0^2/energy S: oscillator strength in units of 1/energy S(\hbar \omega) = 2m/( 3 \pi e^2 \hbar) \omega sum_j chi_j_j S(\hbar \omega) satisfies the f-sum rule: \int_0^\infty dE S(E) = N_el Functions are reported in \hbar.\omega Energy unit is (Ry) TDDFPT_PP : 12.25s CPU 12.44s WALL This run was terminated on: 19:19: 2 31Jan2012 =------------------------------------------------------------------------------= JOB DONE. =------------------------------------------------------------------------------= TDDFPT/Examples/CH4-PBE0/CH4.tddfpt-st-in0000644000175000017500000000016612341371500015557 0ustar mbamba&lr_input prefix="ch4", outdir='./out', restart_step=250, / &lr_control itermax=5, ipol=1 / TDDFPT/Examples/CH4-PBE0/CH4.pw-in0000644000175000017500000000130012341371500014263 0ustar mbamba&control calculation = 'scf' title = 'TDDFPT CH4 Test (TDHF)' restart_mode='from_scratch', pseudo_dir = '../pseudo', outdir='./out', prefix='ch4' etot_conv_thr=1d-6 / &system ibrav = 1, celldm(1) = 15, nat = 5, ntyp = 2, ecutwfc = 25, input_dft = 'pbe0', nosym=.true. / &electrons / &ions / ATOMIC_SPECIES C 1.0 C.pbe-mt_gipaw.UPF H 1.0 H.pbe-vbc.UPF ATOMIC_POSITIONS {Angstrom} C 0.000000000 0.000000000 0.000000000 H 0.642814093 0.642814093 0.642814093 H -0.642814093 -0.642814093 0.642814093 H 0.642814093 -0.642814093 -0.642814093 H -0.642814093 0.642814093 -0.642814093 K_POINTS {gamma} TDDFPT/Examples/CH4-PBE0/CH4.pw-ref0000644000175000017500000003370512341371500014447 0ustar mbamba Program PWSCF v.4.99 starts on 31Jan2012 at 19: 4:54 This program is part of the open-source Quantum ESPRESSO suite for quantum simulation of materials; please cite "P. Giannozzi et al., J. Phys.:Condens. Matter 21 395502 (2009); URL http://www.quantum-espresso.org", in publications or presentations arising from this work. More details at http://www.quantum-espresso.org/quote.php Parallel version (MPI), running on 1 processors EXPERIMENTAL VERSION WITH EXACT EXCHANGE Current dimensions of program PWSCF are: Max number of different atomic species (ntypx) = 10 Max number of k-points (npk) = 40000 Max angular momentum in pseudopotentials (lmaxx) = 3 Waiting for input... Reading input from stdin Warning: card &IONS ignored Warning: card / ignored IMPORTANT: XC functional enforced from input : Exchange-correlation = PBE0 ( 6 4 8 4 0) EXX-fraction = 0.25 Any further DFT definition will be discarded Please, verify this is what you really want file H.pbe-vbc.UPF: wavefunction(s) 0S renormalized gamma-point specific algorithms are used Subspace diagonalization in iterative solution of the eigenvalue problem: a serial algorithm will be used G-vector sticks info -------------------- sticks: dense smooth PW G-vecs: dense smooth PW Sum 1789 1789 437 57051 57051 7123 Tot 895 895 219 Title: TDDFPT CH4 Test (TDHF) bravais-lattice index = 1 lattice parameter (alat) = 15.0000 a.u. unit-cell volume = 3375.0000 (a.u.)^3 number of atoms/cell = 5 number of atomic types = 2 number of electrons = 8.00 number of Kohn-Sham states= 4 kinetic-energy cutoff = 25.0000 Ry charge density cutoff = 100.0000 Ry convergence threshold = 1.0E-06 mixing beta = 0.7000 number of iterations used = 8 plain mixing Exchange-correlation = PBE0 ( 6 4 8 4 0) EXX-fraction = 0.25 celldm(1)= 15.000000 celldm(2)= 0.000000 celldm(3)= 0.000000 celldm(4)= 0.000000 celldm(5)= 0.000000 celldm(6)= 0.000000 crystal axes: (cart. coord. in units of alat) a(1) = ( 1.000000 0.000000 0.000000 ) a(2) = ( 0.000000 1.000000 0.000000 ) a(3) = ( 0.000000 0.000000 1.000000 ) reciprocal axes: (cart. coord. in units 2 pi/alat) b(1) = ( 1.000000 0.000000 0.000000 ) b(2) = ( 0.000000 1.000000 0.000000 ) b(3) = ( 0.000000 0.000000 1.000000 ) PseudoPot. # 1 for C read from file: ../pseudo/C.pbe-mt_gipaw.UPF MD5 check sum: 5ac2f21f2c440b14befe521540822c15 Pseudo is Norm-conserving, Zval = 4.0 Generated by new atomic code, or converted to UPF format Using radial grid of 1073 points, 1 beta functions with: l(1) = 0 PseudoPot. # 2 for H read from file: ../pseudo/H.pbe-vbc.UPF MD5 check sum: 0ad67d0772b4eb71cad78a7d32695431 Pseudo is Norm-conserving, Zval = 1.0 Generated by new atomic code, or converted to UPF format Using radial grid of 325 points, 0 beta functions with: atomic species valence mass pseudopotential C 4.00 1.00000 C ( 1.00) H 1.00 1.00000 H ( 1.00) No symmetry found Cartesian axes site n. atom positions (alat units) 1 C tau( 1) = ( 0.0000000 0.0000000 0.0000000 ) 2 H tau( 2) = ( 0.0809828 0.0809828 0.0809828 ) 3 H tau( 3) = ( -0.0809828 -0.0809828 0.0809828 ) 4 H tau( 4) = ( 0.0809828 -0.0809828 -0.0809828 ) 5 H tau( 5) = ( -0.0809828 0.0809828 -0.0809828 ) number of k points= 1 cart. coord. in units 2pi/alat k( 1) = ( 0.0000000 0.0000000 0.0000000), wk = 2.0000000 Dense grid: 28526 G-vectors FFT dimensions: ( 48, 48, 48) Largest allocated arrays est. size (Mb) dimensions Kohn-Sham Wavefunctions 0.22 Mb ( 3562, 4) NL pseudopotentials 0.05 Mb ( 3562, 1) Each V/rho on FFT grid 1.69 Mb ( 110592) Each G-vector array 0.22 Mb ( 28526) G-vector shells 0.00 Mb ( 477) Largest temporary arrays est. size (Mb) dimensions Auxiliary wavefunctions 0.43 Mb ( 3562, 16) Each subspace H/S matrix 0.00 Mb ( 16, 16) Each matrix 0.00 Mb ( 1, 4) Arrays for rho mixing 13.50 Mb ( 110592, 8) Initial potential from superposition of free atoms Check: negative starting charge= -0.005192 starting charge 7.49994, renormalised to 8.00000 negative rho (up, down): 0.554E-02 0.000E+00 Starting wfc are 12 randomized atomic wfcs total cpu time spent up to now is 0.2 secs per-process dynamical memory: 25.5 Mb Self-consistent Calculation iteration # 1 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 1.00E-02, avg # of iterations = 2.0 negative rho (up, down): 0.150E-02 0.000E+00 total cpu time spent up to now is 0.4 secs total energy = -15.83234847 Ry Harris-Foulkes estimate = -16.10776355 Ry estimated scf accuracy < 0.42404875 Ry iteration # 2 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 5.30E-03, avg # of iterations = 2.0 negative rho (up, down): 0.705E-03 0.000E+00 total cpu time spent up to now is 0.5 secs total energy = -15.92576257 Ry Harris-Foulkes estimate = -16.01127323 Ry estimated scf accuracy < 0.16102472 Ry iteration # 3 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 2.01E-03, avg # of iterations = 2.0 negative rho (up, down): 0.179E-04 0.000E+00 total cpu time spent up to now is 0.7 secs total energy = -15.95831619 Ry Harris-Foulkes estimate = -15.96023389 Ry estimated scf accuracy < 0.00410114 Ry iteration # 4 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 5.13E-05, avg # of iterations = 2.0 negative rho (up, down): 0.119E-05 0.000E+00 total cpu time spent up to now is 0.8 secs total energy = -15.95929620 Ry Harris-Foulkes estimate = -15.95946782 Ry estimated scf accuracy < 0.00046836 Ry iteration # 5 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 5.85E-06, avg # of iterations = 1.0 negative rho (up, down): 0.513E-06 0.000E+00 total cpu time spent up to now is 0.9 secs total energy = -15.95928016 Ry Harris-Foulkes estimate = -15.95931238 Ry estimated scf accuracy < 0.00007516 Ry iteration # 6 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 9.39E-07, avg # of iterations = 2.0 total cpu time spent up to now is 1.0 secs total energy = -15.95928792 Ry Harris-Foulkes estimate = -15.95929215 Ry estimated scf accuracy < 0.00001109 Ry iteration # 7 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 1.39E-07, avg # of iterations = 1.0 total cpu time spent up to now is 1.2 secs total energy = -15.95928789 Ry Harris-Foulkes estimate = -15.95928866 Ry estimated scf accuracy < 0.00000153 Ry iteration # 8 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 1.91E-08, avg # of iterations = 2.0 total cpu time spent up to now is 1.3 secs End of self-consistent calculation k = 0.0000 0.0000 0.0000 ( 3562 PWs) bands (ev): -16.7243 -8.9051 -8.9051 -8.9051 EXX: now go back to refine exchange calculation -2.89769560814124 Self-consistent Calculation iteration # 1 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 1.91E-08, avg # of iterations = 5.0 total cpu time spent up to now is 2.3 secs total energy = -15.97377689 Ry Harris-Foulkes estimate = -15.97382416 Ry estimated scf accuracy < 0.00011378 Ry iteration # 2 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 1.42E-06, avg # of iterations = 1.0 total cpu time spent up to now is 2.7 secs total energy = -15.97378161 Ry Harris-Foulkes estimate = -15.97378397 Ry estimated scf accuracy < 0.00000592 Ry iteration # 3 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 7.40E-08, avg # of iterations = 1.0 total cpu time spent up to now is 3.1 secs End of self-consistent calculation k = 0.0000 0.0000 0.0000 ( 3562 PWs) bands (ev): -19.1276 -10.4102 -10.4102 -10.4102 -2.89769560814124 -2.90023158956834 -2.90291161701211 est. exchange err (dexx) = 0.00007202 Ry ! total energy = -15.97385401 Ry Harris-Foulkes estimate = -15.97385410 Ry estimated scf accuracy < 0.00000028 Ry The total energy is the sum of the following terms: one-electron contribution = -37.57587743 Ry hartree contribution = 18.20755098 Ry xc contribution = -4.82259369 Ry ewald contribution = 6.76829034 Ry - averaged Fock potential = 2.90023159 Ry + Fock energy = -1.45145581 Ry NOW GO BACK TO REFINE HYBRID CALCULATION Self-consistent Calculation iteration # 1 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 7.40E-08, avg # of iterations = 2.0 total cpu time spent up to now is 3.7 secs total energy = -15.97386029 Ry Harris-Foulkes estimate = -15.97386091 Ry estimated scf accuracy < 0.00000121 Ry iteration # 2 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 1.52E-08, avg # of iterations = 2.0 total cpu time spent up to now is 4.2 secs End of self-consistent calculation k = 0.0000 0.0000 0.0000 ( 3562 PWs) bands (ev): -19.1261 -10.4104 -10.4104 -10.4104 -2.90291161701211 -2.90327160824546 -2.90363305604281 est. exchange err (dexx) = 0.00000073 Ry ! total energy = -15.97386108 Ry Harris-Foulkes estimate = -15.97386113 Ry estimated scf accuracy < 0.00000008 Ry The total energy is the sum of the following terms: one-electron contribution = -37.58087741 Ry hartree contribution = 18.21061964 Ry xc contribution = -4.82334872 Ry ewald contribution = 6.76829034 Ry - averaged Fock potential = 2.90327161 Ry + Fock energy = -1.45181653 Ry convergence has been achieved in 2 iterations Writing output data file ch4.save init_run : 0.21s CPU 0.22s WALL ( 1 calls) electrons : 4.00s CPU 4.08s WALL ( 1 calls) Called by init_run: wfcinit : 0.04s CPU 0.04s WALL ( 1 calls) potinit : 0.09s CPU 0.09s WALL ( 1 calls) Called by electrons: c_bands : 2.22s CPU 2.24s WALL ( 13 calls) sum_band : 0.19s CPU 0.19s WALL ( 13 calls) v_of_rho : 0.92s CPU 0.95s WALL ( 15 calls) mix_rho : 0.09s CPU 0.09s WALL ( 13 calls) Called by c_bands: init_us_2 : 0.01s CPU 0.01s WALL ( 27 calls) regterg : 2.21s CPU 2.24s WALL ( 13 calls) Called by *egterg: h_psi : 2.21s CPU 2.24s WALL ( 39 calls) g_psi : 0.01s CPU 0.01s WALL ( 25 calls) rdiaghg : 0.00s CPU 0.00s WALL ( 36 calls) Called by h_psi: add_vuspsi : 0.00s CPU 0.00s WALL ( 39 calls) General routines calbec : 0.01s CPU 0.00s WALL ( 39 calls) fft : 0.55s CPU 0.56s WALL ( 159 calls) ffts : 1.07s CPU 1.07s WALL ( 308 calls) fftw : 0.90s CPU 0.90s WALL ( 350 calls) davcio : 0.00s CPU 0.00s WALL ( 13 calls) Parallel routines EXX routines exx_grid : 0.00s CPU 0.00s WALL ( 1 calls) exxinit : 0.04s CPU 0.04s WALL ( 3 calls) vexx : 1.75s CPU 1.77s WALL ( 16 calls) exxen2 : 0.53s CPU 0.53s WALL ( 8 calls) PWSCF : 4.26s CPU 4.39s WALL This run was terminated on: 19: 4:58 31Jan2012 =------------------------------------------------------------------------------= JOB DONE. =------------------------------------------------------------------------------= TDDFPT/Examples/CH4-PBE0/CH4.tddfpt-ref0000644000175000017500000250715712341371500015317 0ustar mbamba Program TDDFPT v.4.99 starts on 31Jan2012 at 19: 4:58 This program is part of the open-source Quantum ESPRESSO suite for quantum simulation of materials; please cite "P. Giannozzi et al., J. Phys.:Condens. Matter 21 395502 (2009); URL http://www.quantum-espresso.org", in publications or presentations arising from this work. More details at http://www.quantum-espresso.org/quote.php Parallel version (MPI), running on 1 processors ---------------------------------------- This is TDDFPT (Time Dependent Density Functional Perturbation Theory) Sub Version: 0.9 ---------------------------------------- Ultrasoft (Vanderbilt) Pseudopotentials Info: using nr1, nr2, nr3 values from input Info: using nr1s, nr2s, nr3s values from input IMPORTANT: XC functional enforced from input : Exchange-correlation = PBE0 ( 6 4 8 4 0) EXX-fraction = 0.25 Any further DFT definition will be discarded Please, verify this is what you really want file H.pbe-vbc.UPF: wavefunction(s) 0S renormalized G-vector sticks info -------------------- sticks: dense smooth PW G-vecs: dense smooth PW Sum 1789 1789 437 57051 57051 7123 Tot 895 895 219 IMPORTANT: XC functional enforced from input : Exchange-correlation = PBE0 ( 6 4 8 4 0) EXX-fraction = 0.25 Any further DFT definition will be discarded Please, verify this is what you really want EXX fraction changed: 0.25 EXX Screening parameter changed: 0.0000000 Subspace diagonalization in iterative solution of the eigenvalue problem: a serial algorithm will be used Lanczos linear response spectrum calculation Number of Lanczos iterations = 500 Gamma point algorithm Is it hybrid? T lr_wfcinit_spectrum: finished lr_solve_e Norm of initial Lanczos vectors= 1.469000658553140 Starting Lanczos loop 1 Lanczos iteration: 1 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal alpha(00000001)=0.000000000000000E+00 beta (00000002)=0.183408450220056E+01 gamma(00000002)=0.183408450220056E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 2 z1= 1 0.990801512106762E+00 0.000000000000000E+00 z1= 2 -.206818278708672E-06 0.000000000000000E+00 z1= 3 -.557750359514962E-06 0.000000000000000E+00 alpha(00000002)=0.000000000000000E+00 beta (00000003)=0.572337791980275E+01 gamma(00000003)=0.572337791980275E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 3 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000003)=0.000000000000000E+00 beta (00000004)=0.138861127079790E+02 gamma(00000004)=0.138861127079790E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 4 z1= 1 -.330755338053318E+00 0.000000000000000E+00 z1= 2 0.551723921074238E-07 0.000000000000000E+00 z1= 3 0.209001777966593E-06 0.000000000000000E+00 alpha(00000004)=0.000000000000000E+00 beta (00000005)=0.123143167044091E+02 gamma(00000005)=0.123143167044091E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 5 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000005)=0.000000000000000E+00 beta (00000006)=0.137542233817634E+02 gamma(00000006)=0.137542233817634E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 6 z1= 1 0.266479374533287E+00 0.000000000000000E+00 z1= 2 -.345410147825544E-07 0.000000000000000E+00 z1= 3 -.190040151779427E-06 0.000000000000000E+00 alpha(00000006)=0.000000000000000E+00 beta (00000007)=0.126557996990487E+02 gamma(00000007)=0.126557996990487E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 7 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000007)=0.000000000000000E+00 beta (00000008)=0.134527259168843E+02 gamma(00000008)=0.134527259168843E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 8 z1= 1 -.233104144742698E+00 0.000000000000000E+00 z1= 2 0.337478301367690E-07 0.000000000000000E+00 z1= 3 0.196863631261174E-06 0.000000000000000E+00 alpha(00000008)=0.000000000000000E+00 beta (00000009)=0.127405131911758E+02 gamma(00000009)=0.127405131911758E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 9 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000009)=0.000000000000000E+00 beta (00000010)=0.134621137105327E+02 gamma(00000010)=0.134621137105327E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 10 z1= 1 0.208828357220264E+00 0.000000000000000E+00 z1= 2 -.387145685678929E-07 0.000000000000000E+00 z1= 3 -.210043841722841E-06 0.000000000000000E+00 alpha(00000010)=0.000000000000000E+00 beta (00000011)=0.127778328661942E+02 gamma(00000011)=0.127778328661942E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 11 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000011)=0.000000000000000E+00 beta (00000012)=0.135178856890084E+02 gamma(00000012)=0.135178856890084E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 12 z1= 1 -.188479957750897E+00 0.000000000000000E+00 z1= 2 0.382107114386965E-07 0.000000000000000E+00 z1= 3 0.215909853054034E-06 0.000000000000000E+00 alpha(00000012)=0.000000000000000E+00 beta (00000013)=0.127513453529115E+02 gamma(00000013)=0.127513453529115E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 13 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000013)=0.000000000000000E+00 beta (00000014)=0.134908015451298E+02 gamma(00000014)=0.134908015451298E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 14 z1= 1 0.170998877853046E+00 0.000000000000000E+00 z1= 2 -.292679161336372E-07 0.000000000000000E+00 z1= 3 -.211104347056131E-06 0.000000000000000E+00 alpha(00000014)=0.000000000000000E+00 beta (00000015)=0.127936777883296E+02 gamma(00000015)=0.127936777883296E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 15 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000015)=0.000000000000000E+00 beta (00000016)=0.135567099953685E+02 gamma(00000016)=0.135567099953685E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 16 z1= 1 -.155434483050036E+00 0.000000000000000E+00 z1= 2 0.162689330752801E-07 0.000000000000000E+00 z1= 3 0.198961237868681E-06 0.000000000000000E+00 alpha(00000016)=0.000000000000000E+00 beta (00000017)=0.127918127831823E+02 gamma(00000017)=0.127918127831823E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 17 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000017)=0.000000000000000E+00 beta (00000018)=0.133937079866094E+02 gamma(00000018)=0.133937079866094E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 18 z1= 1 0.143390603787755E+00 0.000000000000000E+00 z1= 2 0.532952346751076E-09 0.000000000000000E+00 z1= 3 -.182021512791595E-06 0.000000000000000E+00 alpha(00000018)=0.000000000000000E+00 beta (00000019)=0.126916724330129E+02 gamma(00000019)=0.126916724330129E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 19 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000019)=0.000000000000000E+00 beta (00000020)=0.133733640739313E+02 gamma(00000020)=0.133733640739313E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 20 z1= 1 -.131850334912017E+00 0.000000000000000E+00 z1= 2 -.177317948019985E-07 0.000000000000000E+00 z1= 3 0.161755139225714E-06 0.000000000000000E+00 alpha(00000020)=0.000000000000000E+00 beta (00000021)=0.127260421544093E+02 gamma(00000021)=0.127260421544093E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 21 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000021)=0.000000000000000E+00 beta (00000022)=0.134820094432615E+02 gamma(00000022)=0.134820094432615E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 22 z1= 1 0.120961280633643E+00 0.000000000000000E+00 z1= 2 0.329060794944901E-07 0.000000000000000E+00 z1= 3 -.142145273958078E-06 0.000000000000000E+00 alpha(00000022)=0.000000000000000E+00 beta (00000023)=0.129128503072155E+02 gamma(00000023)=0.129128503072155E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 23 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000023)=0.000000000000000E+00 beta (00000024)=0.132837297762008E+02 gamma(00000024)=0.132837297762008E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 24 z1= 1 -.114671840823056E+00 0.000000000000000E+00 z1= 2 -.469955427043374E-07 0.000000000000000E+00 z1= 3 0.130312359574933E-06 0.000000000000000E+00 alpha(00000024)=0.000000000000000E+00 beta (00000025)=0.125388181891172E+02 gamma(00000025)=0.125388181891172E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 25 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000025)=0.000000000000000E+00 beta (00000026)=0.135589533352613E+02 gamma(00000026)=0.135589533352613E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 26 z1= 1 0.103641848114928E+00 0.000000000000000E+00 z1= 2 0.572095581780237E-07 0.000000000000000E+00 z1= 3 -.113832088400288E-06 0.000000000000000E+00 alpha(00000026)=0.000000000000000E+00 beta (00000027)=0.129337652531344E+02 gamma(00000027)=0.129337652531344E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 27 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000027)=0.000000000000000E+00 beta (00000028)=0.133335181979899E+02 gamma(00000028)=0.133335181979899E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 28 z1= 1 -.985035255252265E-01 0.000000000000000E+00 z1= 2 -.676731486863938E-07 0.000000000000000E+00 z1= 3 0.107441478644499E-06 0.000000000000000E+00 alpha(00000028)=0.000000000000000E+00 beta (00000029)=0.128951590752574E+02 gamma(00000029)=0.128951590752574E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 29 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000029)=0.000000000000000E+00 beta (00000030)=0.135410730110895E+02 gamma(00000030)=0.135410730110895E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 30 z1= 1 0.920548997243936E-01 0.000000000000000E+00 z1= 2 0.772211675376458E-07 0.000000000000000E+00 z1= 3 -.986574513308150E-07 0.000000000000000E+00 alpha(00000030)=0.000000000000000E+00 beta (00000031)=0.127912919847338E+02 gamma(00000031)=0.127912919847338E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 31 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000031)=0.000000000000000E+00 beta (00000032)=0.133985346278288E+02 gamma(00000032)=0.133985346278288E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 32 z1= 1 -.864161511839850E-01 0.000000000000000E+00 z1= 2 -.898836509041767E-07 0.000000000000000E+00 z1= 3 0.857318979323798E-07 0.000000000000000E+00 alpha(00000032)=0.000000000000000E+00 beta (00000033)=0.127353150495760E+02 gamma(00000033)=0.127353150495760E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 33 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000033)=0.000000000000000E+00 beta (00000034)=0.135903246521301E+02 gamma(00000034)=0.135903246521301E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 34 z1= 1 0.797404227007520E-01 0.000000000000000E+00 z1= 2 0.103321049604865E-06 0.000000000000000E+00 z1= 3 -.693692443834437E-07 0.000000000000000E+00 alpha(00000034)=0.000000000000000E+00 beta (00000035)=0.125676813226261E+02 gamma(00000035)=0.125676813226261E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 35 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000035)=0.000000000000000E+00 beta (00000036)=0.131270516132765E+02 gamma(00000036)=0.131270516132765E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 36 z1= 1 -.750282317308601E-01 0.000000000000000E+00 z1= 2 -.123686405673062E-06 0.000000000000000E+00 z1= 3 0.482905791131770E-07 0.000000000000000E+00 alpha(00000036)=0.000000000000000E+00 beta (00000037)=0.128541689325886E+02 gamma(00000037)=0.128541689325886E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 37 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000037)=0.000000000000000E+00 beta (00000038)=0.133559038858937E+02 gamma(00000038)=0.133559038858937E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 38 z1= 1 0.711339045034596E-01 0.000000000000000E+00 z1= 2 0.147240789763817E-06 0.000000000000000E+00 z1= 3 -.236003354341791E-07 0.000000000000000E+00 alpha(00000038)=0.000000000000000E+00 beta (00000039)=0.128572418781170E+02 gamma(00000039)=0.128572418781170E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 39 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000039)=0.000000000000000E+00 beta (00000040)=0.131516061040807E+02 gamma(00000040)=0.131516061040807E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 40 z1= 1 -.685795360374054E-01 0.000000000000000E+00 z1= 2 -.178322343718541E-06 0.000000000000000E+00 z1= 3 -.716375292766913E-08 0.000000000000000E+00 alpha(00000040)=0.000000000000000E+00 beta (00000041)=0.127262525730963E+02 gamma(00000041)=0.127262525730963E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 41 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000041)=0.000000000000000E+00 beta (00000042)=0.135352414829818E+02 gamma(00000042)=0.135352414829818E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 42 z1= 1 0.635429311323104E-01 0.000000000000000E+00 z1= 2 0.202393676156272E-06 0.000000000000000E+00 z1= 3 0.393362801919157E-07 0.000000000000000E+00 alpha(00000042)=0.000000000000000E+00 beta (00000043)=0.127360209861087E+02 gamma(00000043)=0.127360209861087E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 43 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000043)=0.000000000000000E+00 beta (00000044)=0.133909947346649E+02 gamma(00000044)=0.133909947346649E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 44 z1= 1 -.595803738486022E-01 0.000000000000000E+00 z1= 2 -.224844971822603E-06 0.000000000000000E+00 z1= 3 -.655538967032909E-07 0.000000000000000E+00 alpha(00000044)=0.000000000000000E+00 beta (00000045)=0.124244393218229E+02 gamma(00000045)=0.124244393218229E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 45 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000045)=0.000000000000000E+00 beta (00000046)=0.132663029183027E+02 gamma(00000046)=0.132663029183027E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 46 z1= 1 0.549391910292488E-01 0.000000000000000E+00 z1= 2 0.242373233923059E-06 0.000000000000000E+00 z1= 3 0.876920094603287E-07 0.000000000000000E+00 alpha(00000046)=0.000000000000000E+00 beta (00000047)=0.123512740781830E+02 gamma(00000047)=0.123512740781830E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 47 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000047)=0.000000000000000E+00 beta (00000048)=0.133709998188585E+02 gamma(00000048)=0.133709998188585E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 48 z1= 1 -.497885874986359E-01 0.000000000000000E+00 z1= 2 -.257160673032206E-06 0.000000000000000E+00 z1= 3 -.107527338009256E-06 0.000000000000000E+00 alpha(00000048)=0.000000000000000E+00 beta (00000049)=0.131080332186564E+02 gamma(00000049)=0.131080332186564E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 49 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000049)=0.000000000000000E+00 beta (00000050)=0.136794181587459E+02 gamma(00000050)=0.136794181587459E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 50 z1= 1 0.469847512152605E-01 0.000000000000000E+00 z1= 2 0.275708508305945E-06 0.000000000000000E+00 z1= 3 0.123596476919383E-06 0.000000000000000E+00 alpha(00000050)=0.000000000000000E+00 beta (00000051)=0.126058121777806E+02 gamma(00000051)=0.126058121777806E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 51 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000051)=0.000000000000000E+00 beta (00000052)=0.133780909318368E+02 gamma(00000052)=0.133780909318368E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 52 z1= 1 -.435539133320638E-01 0.000000000000000E+00 z1= 2 -.285933964793567E-06 0.000000000000000E+00 z1= 3 -.132720911510086E-06 0.000000000000000E+00 alpha(00000052)=0.000000000000000E+00 beta (00000053)=0.126303852849377E+02 gamma(00000053)=0.126303852849377E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 53 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000053)=0.000000000000000E+00 beta (00000054)=0.130423028873631E+02 gamma(00000054)=0.130423028873631E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 54 z1= 1 0.415353248578945E-01 0.000000000000000E+00 z1= 2 0.299724171864447E-06 0.000000000000000E+00 z1= 3 0.139179391287977E-06 0.000000000000000E+00 alpha(00000054)=0.000000000000000E+00 beta (00000055)=0.132443028754762E+02 gamma(00000055)=0.132443028754762E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 55 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000055)=0.000000000000000E+00 beta (00000056)=0.133031868971083E+02 gamma(00000056)=0.133031868971083E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 56 z1= 1 -.408112222690408E-01 0.000000000000000E+00 z1= 2 -.315809451247213E-06 0.000000000000000E+00 z1= 3 -.141750613028707E-06 0.000000000000000E+00 alpha(00000056)=0.000000000000000E+00 beta (00000057)=0.130912322830087E+02 gamma(00000057)=0.130912322830087E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 57 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000057)=0.000000000000000E+00 beta (00000058)=0.131870326605284E+02 gamma(00000058)=0.131870326605284E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 58 z1= 1 0.399652897560185E-01 0.000000000000000E+00 z1= 2 0.331305032345852E-06 0.000000000000000E+00 z1= 3 0.144787105235689E-06 0.000000000000000E+00 alpha(00000058)=0.000000000000000E+00 beta (00000059)=0.128670309943098E+02 gamma(00000059)=0.128670309943098E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 59 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000059)=0.000000000000000E+00 beta (00000060)=0.134508629003567E+02 gamma(00000060)=0.134508629003567E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 60 z1= 1 -.377199723855010E-01 0.000000000000000E+00 z1= 2 -.334307046232461E-06 0.000000000000000E+00 z1= 3 -.143194183226114E-06 0.000000000000000E+00 alpha(00000060)=0.000000000000000E+00 beta (00000061)=0.130151321721548E+02 gamma(00000061)=0.130151321721548E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 61 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000061)=0.000000000000000E+00 beta (00000062)=0.137093708204536E+02 gamma(00000062)=0.137093708204536E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 62 z1= 1 0.352299147997056E-01 0.000000000000000E+00 z1= 2 0.334569156286608E-06 0.000000000000000E+00 z1= 3 0.140108299425887E-06 0.000000000000000E+00 alpha(00000062)=0.000000000000000E+00 beta (00000063)=0.129991548007441E+02 gamma(00000063)=0.129991548007441E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 63 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000063)=0.000000000000000E+00 beta (00000064)=0.132904720655507E+02 gamma(00000064)=0.132904720655507E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 64 z1= 1 -.339058820557000E-01 0.000000000000000E+00 z1= 2 -.348656554029735E-06 0.000000000000000E+00 z1= 3 -.144975924877035E-06 0.000000000000000E+00 alpha(00000064)=0.000000000000000E+00 beta (00000065)=0.124219742900231E+02 gamma(00000065)=0.124219742900231E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 65 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000065)=0.000000000000000E+00 beta (00000066)=0.132809547310775E+02 gamma(00000066)=0.132809547310775E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 66 z1= 1 0.312993759546327E-01 0.000000000000000E+00 z1= 2 0.351040587976553E-06 0.000000000000000E+00 z1= 3 0.148211909980177E-06 0.000000000000000E+00 alpha(00000066)=0.000000000000000E+00 beta (00000067)=0.131508963154464E+02 gamma(00000067)=0.131508963154464E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 67 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000067)=0.000000000000000E+00 beta (00000068)=0.137579513514665E+02 gamma(00000068)=0.137579513514665E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 68 z1= 1 -.296505815571540E-01 0.000000000000000E+00 z1= 2 -.359165810907662E-06 0.000000000000000E+00 z1= 3 -.154805981289995E-06 0.000000000000000E+00 alpha(00000068)=0.000000000000000E+00 beta (00000069)=0.129305386114265E+02 gamma(00000069)=0.129305386114265E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 69 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000069)=0.000000000000000E+00 beta (00000070)=0.131645983768958E+02 gamma(00000070)=0.131645983768958E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 70 z1= 1 0.288886833559764E-01 0.000000000000000E+00 z1= 2 0.378166404029975E-06 0.000000000000000E+00 z1= 3 0.165055254357400E-06 0.000000000000000E+00 alpha(00000070)=0.000000000000000E+00 beta (00000071)=0.126044510922592E+02 gamma(00000071)=0.126044510922592E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 71 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000071)=0.000000000000000E+00 beta (00000072)=0.136173433688798E+02 gamma(00000072)=0.136173433688798E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 72 z1= 1 -.265938135870987E-01 0.000000000000000E+00 z1= 2 -.378387532898664E-06 0.000000000000000E+00 z1= 3 -.170385207469946E-06 0.000000000000000E+00 alpha(00000072)=0.000000000000000E+00 beta (00000073)=0.127244322896537E+02 gamma(00000073)=0.127244322896537E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 73 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000073)=0.000000000000000E+00 beta (00000074)=0.131219636743117E+02 gamma(00000074)=0.131219636743117E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 74 z1= 1 0.255975309194555E-01 0.000000000000000E+00 z1= 2 0.398245236456554E-06 0.000000000000000E+00 z1= 3 0.187383756777675E-06 0.000000000000000E+00 alpha(00000074)=0.000000000000000E+00 beta (00000075)=0.124271688554499E+02 gamma(00000075)=0.124271688554499E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 75 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000075)=0.000000000000000E+00 beta (00000076)=0.133410219794684E+02 gamma(00000076)=0.133410219794684E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 76 z1= 1 -.236183088364633E-01 0.000000000000000E+00 z1= 2 -.400641193665230E-06 0.000000000000000E+00 z1= 3 -.193993545808020E-06 0.000000000000000E+00 alpha(00000076)=0.000000000000000E+00 beta (00000077)=0.127582466760072E+02 gamma(00000077)=0.127582466760072E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 77 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000077)=0.000000000000000E+00 beta (00000078)=0.137338060816145E+02 gamma(00000078)=0.137338060816145E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 78 z1= 1 0.219149686067193E-01 0.000000000000000E+00 z1= 2 0.403268025181425E-06 0.000000000000000E+00 z1= 3 0.200499133289934E-06 0.000000000000000E+00 alpha(00000078)=0.000000000000000E+00 beta (00000079)=0.125533715897717E+02 gamma(00000079)=0.125533715897717E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 79 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000079)=0.000000000000000E+00 beta (00000080)=0.132067530337304E+02 gamma(00000080)=0.132067530337304E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 80 z1= 1 -.209237146444487E-01 0.000000000000000E+00 z1= 2 -.415816706587913E-06 0.000000000000000E+00 z1= 3 -.209780145568085E-06 0.000000000000000E+00 alpha(00000080)=0.000000000000000E+00 beta (00000081)=0.127296775864505E+02 gamma(00000081)=0.127296775864505E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 81 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000081)=0.000000000000000E+00 beta (00000082)=0.138731633360885E+02 gamma(00000082)=0.138731633360885E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 82 z1= 1 0.193308886197496E-01 0.000000000000000E+00 z1= 2 0.410778704957454E-06 0.000000000000000E+00 z1= 3 0.208315356656393E-06 0.000000000000000E+00 alpha(00000082)=0.000000000000000E+00 beta (00000083)=0.126812280683391E+02 gamma(00000083)=0.126812280683391E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 83 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000083)=0.000000000000000E+00 beta (00000084)=0.130964109287816E+02 gamma(00000084)=0.130964109287816E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 84 z1= 1 -.188110009468296E-01 0.000000000000000E+00 z1= 2 -.429903514377605E-06 0.000000000000000E+00 z1= 3 -.220495189969319E-06 0.000000000000000E+00 alpha(00000084)=0.000000000000000E+00 beta (00000085)=0.126005779569937E+02 gamma(00000085)=0.126005779569937E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 85 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000085)=0.000000000000000E+00 beta (00000086)=0.139568598922201E+02 gamma(00000086)=0.139568598922201E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 86 z1= 1 0.169458922118096E-01 0.000000000000000E+00 z1= 2 0.417919797584404E-06 0.000000000000000E+00 z1= 3 0.217082729946430E-06 0.000000000000000E+00 alpha(00000086)=0.000000000000000E+00 beta (00000087)=0.125283237477704E+02 gamma(00000087)=0.125283237477704E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 87 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000087)=0.000000000000000E+00 beta (00000088)=0.130426645961528E+02 gamma(00000088)=0.130426645961528E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 88 z1= 1 -.160287222962093E-01 0.000000000000000E+00 z1= 2 -.430364599426220E-06 0.000000000000000E+00 z1= 3 -.222041357732586E-06 0.000000000000000E+00 alpha(00000088)=0.000000000000000E+00 beta (00000089)=0.129410186315246E+02 gamma(00000089)=0.129410186315246E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 89 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000089)=0.000000000000000E+00 beta (00000090)=0.135148916405113E+02 gamma(00000090)=0.135148916405113E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 90 z1= 1 0.149680345279133E-01 0.000000000000000E+00 z1= 2 0.434635098292210E-06 0.000000000000000E+00 z1= 3 0.217972698310191E-06 0.000000000000000E+00 alpha(00000090)=0.000000000000000E+00 beta (00000091)=0.124482051929581E+02 gamma(00000091)=0.124482051929581E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 91 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000091)=0.000000000000000E+00 beta (00000092)=0.130591006843172E+02 gamma(00000092)=0.130591006843172E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 92 z1= 1 -.138409787643906E-01 0.000000000000000E+00 z1= 2 -.439897779817150E-06 0.000000000000000E+00 z1= 3 -.214400059003403E-06 0.000000000000000E+00 alpha(00000092)=0.000000000000000E+00 beta (00000093)=0.130360461279675E+02 gamma(00000093)=0.130360461279675E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 93 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000093)=0.000000000000000E+00 beta (00000094)=0.129280166763584E+02 gamma(00000094)=0.129280166763584E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 94 z1= 1 0.135223906668072E-01 0.000000000000000E+00 z1= 2 0.465237537189411E-06 0.000000000000000E+00 z1= 3 0.218097639927139E-06 0.000000000000000E+00 alpha(00000094)=0.000000000000000E+00 beta (00000095)=0.122336920732379E+02 gamma(00000095)=0.122336920732379E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 95 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000095)=0.000000000000000E+00 beta (00000096)=0.128080678951569E+02 gamma(00000096)=0.128080678951569E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 96 z1= 1 -.125727556675305E-01 0.000000000000000E+00 z1= 2 -.465086218929406E-06 0.000000000000000E+00 z1= 3 -.207763320710791E-06 0.000000000000000E+00 alpha(00000096)=0.000000000000000E+00 beta (00000097)=0.127706175517162E+02 gamma(00000097)=0.127706175517162E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 97 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000097)=0.000000000000000E+00 beta (00000098)=0.126718459056661E+02 gamma(00000098)=0.126718459056661E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 98 z1= 1 0.122626365259059E-01 0.000000000000000E+00 z1= 2 0.490883337027348E-06 0.000000000000000E+00 z1= 3 0.211587663601770E-06 0.000000000000000E+00 alpha(00000098)=0.000000000000000E+00 beta (00000099)=0.122002915694685E+02 gamma(00000099)=0.122002915694685E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 99 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000099)=0.000000000000000E+00 beta (00000100)=0.134328814289938E+02 gamma(00000100)=0.134328814289938E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 100 z1= 1 -.107983052160623E-01 0.000000000000000E+00 z1= 2 -.460968793339692E-06 0.000000000000000E+00 z1= 3 -.186625574515042E-06 0.000000000000000E+00 alpha(00000100)=0.000000000000000E+00 beta (00000101)=0.129919936785592E+02 gamma(00000101)=0.129919936785592E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 101 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000101)=0.000000000000000E+00 beta (00000102)=0.132098932006755E+02 gamma(00000102)=0.132098932006755E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 102 z1= 1 0.104500882349689E-01 0.000000000000000E+00 z1= 2 0.463207988334047E-06 0.000000000000000E+00 z1= 3 0.174258549446096E-06 0.000000000000000E+00 alpha(00000102)=0.000000000000000E+00 beta (00000103)=0.133614108096856E+02 gamma(00000103)=0.133614108096856E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 103 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000103)=0.000000000000000E+00 beta (00000104)=0.128938377113308E+02 gamma(00000104)=0.128938377113308E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 104 z1= 1 -.110564157293310E-01 0.000000000000000E+00 z1= 2 -.492531189857232E-06 0.000000000000000E+00 z1= 3 -.177858454445193E-06 0.000000000000000E+00 alpha(00000104)=0.000000000000000E+00 beta (00000105)=0.132018183507363E+02 gamma(00000105)=0.132018183507363E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 105 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000105)=0.000000000000000E+00 beta (00000106)=0.137901557603029E+02 gamma(00000106)=0.137901557603029E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 106 z1= 1 0.109269499378556E-01 0.000000000000000E+00 z1= 2 0.483948906613782E-06 0.000000000000000E+00 z1= 3 0.168803498651338E-06 0.000000000000000E+00 alpha(00000106)=0.000000000000000E+00 beta (00000107)=0.131785117650295E+02 gamma(00000107)=0.131785117650295E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 107 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000107)=0.000000000000000E+00 beta (00000108)=0.132913100077888E+02 gamma(00000108)=0.132913100077888E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 108 z1= 1 -.111478369367154E-01 0.000000000000000E+00 z1= 2 -.492800347775407E-06 0.000000000000000E+00 z1= 3 -.166325015432331E-06 0.000000000000000E+00 alpha(00000108)=0.000000000000000E+00 beta (00000109)=0.131813980536400E+02 gamma(00000109)=0.131813980536400E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 109 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000109)=0.000000000000000E+00 beta (00000110)=0.128018472931370E+02 gamma(00000110)=0.128018472931370E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 110 z1= 1 0.117677850705506E-01 0.000000000000000E+00 z1= 2 0.518867672539419E-06 0.000000000000000E+00 z1= 3 0.167703718091314E-06 0.000000000000000E+00 alpha(00000110)=0.000000000000000E+00 beta (00000111)=0.130264155901158E+02 gamma(00000111)=0.130264155901158E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 111 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000111)=0.000000000000000E+00 beta (00000112)=0.134223618104938E+02 gamma(00000112)=0.134223618104938E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 112 z1= 1 -.115152183337868E-01 0.000000000000000E+00 z1= 2 -.507013014631325E-06 0.000000000000000E+00 z1= 3 -.149852706335732E-06 0.000000000000000E+00 alpha(00000112)=0.000000000000000E+00 beta (00000113)=0.126782688597615E+02 gamma(00000113)=0.126782688597615E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 113 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000113)=0.000000000000000E+00 beta (00000114)=0.131589978713592E+02 gamma(00000114)=0.131589978713592E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 114 z1= 1 0.111951522350173E-01 0.000000000000000E+00 z1= 2 0.491672133874632E-06 0.000000000000000E+00 z1= 3 0.131573558227391E-06 0.000000000000000E+00 alpha(00000114)=0.000000000000000E+00 beta (00000115)=0.124669192782448E+02 gamma(00000115)=0.124669192782448E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 115 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000115)=0.000000000000000E+00 beta (00000116)=0.134367308173865E+02 gamma(00000116)=0.134367308173865E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 116 z1= 1 -.107811726781716E-01 0.000000000000000E+00 z1= 2 -.465305689067649E-06 0.000000000000000E+00 z1= 3 -.117063901808323E-06 0.000000000000000E+00 alpha(00000116)=0.000000000000000E+00 beta (00000117)=0.123608407302852E+02 gamma(00000117)=0.123608407302852E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 117 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000117)=0.000000000000000E+00 beta (00000118)=0.132506559873111E+02 gamma(00000118)=0.132506559873111E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 118 z1= 1 0.103649911135746E-01 0.000000000000000E+00 z1= 2 0.445990527368420E-06 0.000000000000000E+00 z1= 3 0.105239046661182E-06 0.000000000000000E+00 alpha(00000118)=0.000000000000000E+00 beta (00000119)=0.127796529431195E+02 gamma(00000119)=0.127796529431195E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 119 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000119)=0.000000000000000E+00 beta (00000120)=0.132042581066825E+02 gamma(00000120)=0.132042581066825E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 120 z1= 1 -.100927594617390E-01 0.000000000000000E+00 z1= 2 -.437386896503383E-06 0.000000000000000E+00 z1= 3 -.901404717448123E-07 0.000000000000000E+00 alpha(00000120)=0.000000000000000E+00 beta (00000121)=0.123933037514986E+02 gamma(00000121)=0.123933037514986E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 121 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000121)=0.000000000000000E+00 beta (00000122)=0.129982087260397E+02 gamma(00000122)=0.129982087260397E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 122 z1= 1 0.968948752924931E-02 0.000000000000000E+00 z1= 2 0.422083005650886E-06 0.000000000000000E+00 z1= 3 0.740708491330649E-07 0.000000000000000E+00 alpha(00000122)=0.000000000000000E+00 beta (00000123)=0.128338249455899E+02 gamma(00000123)=0.128338249455899E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 123 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000123)=0.000000000000000E+00 beta (00000124)=0.135790443133604E+02 gamma(00000124)=0.135790443133604E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 124 z1= 1 -.907009397206911E-02 0.000000000000000E+00 z1= 2 -.400788790292858E-06 0.000000000000000E+00 z1= 3 -.557670702793639E-07 0.000000000000000E+00 alpha(00000124)=0.000000000000000E+00 beta (00000125)=0.128904235925512E+02 gamma(00000125)=0.128904235925512E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 125 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000125)=0.000000000000000E+00 beta (00000126)=0.135564027062466E+02 gamma(00000126)=0.135564027062466E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 126 z1= 1 0.862236457195473E-02 0.000000000000000E+00 z1= 2 0.388446106249635E-06 0.000000000000000E+00 z1= 3 0.481070199249284E-07 0.000000000000000E+00 alpha(00000126)=0.000000000000000E+00 beta (00000127)=0.127971575482445E+02 gamma(00000127)=0.127971575482445E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 127 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000127)=0.000000000000000E+00 beta (00000128)=0.136536960960436E+02 gamma(00000128)=0.136536960960436E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 128 z1= 1 -.825991098629573E-02 0.000000000000000E+00 z1= 2 -.377292395001630E-06 0.000000000000000E+00 z1= 3 -.496214290438696E-07 0.000000000000000E+00 alpha(00000128)=0.000000000000000E+00 beta (00000129)=0.127278120256212E+02 gamma(00000129)=0.127278120256212E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 129 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000129)=0.000000000000000E+00 beta (00000130)=0.130491572021942E+02 gamma(00000130)=0.130491572021942E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 130 z1= 1 0.813358944177845E-02 0.000000000000000E+00 z1= 2 0.376126386236394E-06 0.000000000000000E+00 z1= 3 0.461716413227564E-07 0.000000000000000E+00 alpha(00000130)=0.000000000000000E+00 beta (00000131)=0.130564082707048E+02 gamma(00000131)=0.130564082707048E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 131 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000131)=0.000000000000000E+00 beta (00000132)=0.136082471955517E+02 gamma(00000132)=0.136082471955517E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 132 z1= 1 -.780709258470249E-02 0.000000000000000E+00 z1= 2 -.368334753208382E-06 0.000000000000000E+00 z1= 3 -.417782493322694E-07 0.000000000000000E+00 alpha(00000132)=0.000000000000000E+00 beta (00000133)=0.122641336931360E+02 gamma(00000133)=0.122641336931360E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 133 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000133)=0.000000000000000E+00 beta (00000134)=0.133450915484229E+02 gamma(00000134)=0.133450915484229E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 134 z1= 1 0.713742802710296E-02 0.000000000000000E+00 z1= 2 0.351281853045241E-06 0.000000000000000E+00 z1= 3 0.422546184934008E-07 0.000000000000000E+00 alpha(00000134)=0.000000000000000E+00 beta (00000135)=0.129189966746347E+02 gamma(00000135)=0.129189966746347E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 135 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000135)=0.000000000000000E+00 beta (00000136)=0.133088307630519E+02 gamma(00000136)=0.133088307630519E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 136 z1= 1 -.681476303778151E-02 0.000000000000000E+00 z1= 2 -.356060544723716E-06 0.000000000000000E+00 z1= 3 -.504530442355100E-07 0.000000000000000E+00 alpha(00000136)=0.000000000000000E+00 beta (00000137)=0.119893043353616E+02 gamma(00000137)=0.119893043353616E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 137 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000137)=0.000000000000000E+00 beta (00000138)=0.134043269913691E+02 gamma(00000138)=0.134043269913691E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 138 z1= 1 0.596164188225965E-02 0.000000000000000E+00 z1= 2 0.330799736814741E-06 0.000000000000000E+00 z1= 3 0.499297228232637E-07 0.000000000000000E+00 alpha(00000138)=0.000000000000000E+00 beta (00000139)=0.129875630043215E+02 gamma(00000139)=0.129875630043215E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 139 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000139)=0.000000000000000E+00 beta (00000140)=0.133426479472382E+02 gamma(00000140)=0.133426479472382E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 140 z1= 1 -.573467985803612E-02 0.000000000000000E+00 z1= 2 -.334770750461122E-06 0.000000000000000E+00 z1= 3 -.530969490979138E-07 0.000000000000000E+00 alpha(00000140)=0.000000000000000E+00 beta (00000141)=0.130003725469227E+02 gamma(00000141)=0.130003725469227E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 141 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000141)=0.000000000000000E+00 beta (00000142)=0.134435866644228E+02 gamma(00000142)=0.134435866644228E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 142 z1= 1 0.582662542154760E-02 0.000000000000000E+00 z1= 2 0.338831306635409E-06 0.000000000000000E+00 z1= 3 0.589555696275945E-07 0.000000000000000E+00 alpha(00000142)=0.000000000000000E+00 beta (00000143)=0.125646158482432E+02 gamma(00000143)=0.125646158482432E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 143 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000143)=0.000000000000000E+00 beta (00000144)=0.137008228480757E+02 gamma(00000144)=0.137008228480757E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 144 z1= 1 -.579861995284401E-02 0.000000000000000E+00 z1= 2 -.321010191144111E-06 0.000000000000000E+00 z1= 3 -.562370068126275E-07 0.000000000000000E+00 alpha(00000144)=0.000000000000000E+00 beta (00000145)=0.132286706186803E+02 gamma(00000145)=0.132286706186803E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 145 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000145)=0.000000000000000E+00 beta (00000146)=0.139206134617369E+02 gamma(00000146)=0.139206134617369E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 146 z1= 1 0.599595112581423E-02 0.000000000000000E+00 z1= 2 0.313510598043062E-06 0.000000000000000E+00 z1= 3 0.546703654387068E-07 0.000000000000000E+00 alpha(00000146)=0.000000000000000E+00 beta (00000147)=0.127797027737942E+02 gamma(00000147)=0.127797027737942E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 147 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000147)=0.000000000000000E+00 beta (00000148)=0.129455479127106E+02 gamma(00000148)=0.129455479127106E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 148 z1= 1 -.646285672711677E-02 0.000000000000000E+00 z1= 2 -.323257651113976E-06 0.000000000000000E+00 z1= 3 -.605585265406328E-07 0.000000000000000E+00 alpha(00000148)=0.000000000000000E+00 beta (00000149)=0.129403294596237E+02 gamma(00000149)=0.129403294596237E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 149 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000149)=0.000000000000000E+00 beta (00000150)=0.130980301459057E+02 gamma(00000150)=0.130980301459057E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 150 z1= 1 0.673197658492667E-02 0.000000000000000E+00 z1= 2 0.329382634334241E-06 0.000000000000000E+00 z1= 3 0.617511665169934E-07 0.000000000000000E+00 alpha(00000150)=0.000000000000000E+00 beta (00000151)=0.128424230496935E+02 gamma(00000151)=0.128424230496935E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 151 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000151)=0.000000000000000E+00 beta (00000152)=0.139447998859627E+02 gamma(00000152)=0.139447998859627E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 152 z1= 1 -.644033123321714E-02 0.000000000000000E+00 z1= 2 -.304872634401820E-06 0.000000000000000E+00 z1= 3 -.475266115594619E-07 0.000000000000000E+00 alpha(00000152)=0.000000000000000E+00 beta (00000153)=0.124657942894967E+02 gamma(00000153)=0.124657942894967E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 153 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000153)=0.000000000000000E+00 beta (00000154)=0.135700266552697E+02 gamma(00000154)=0.135700266552697E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 154 z1= 1 0.616274454292662E-02 0.000000000000000E+00 z1= 2 0.278420942530222E-06 0.000000000000000E+00 z1= 3 0.296975374474220E-07 0.000000000000000E+00 alpha(00000154)=0.000000000000000E+00 beta (00000155)=0.124067846322273E+02 gamma(00000155)=0.124067846322273E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 155 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000155)=0.000000000000000E+00 beta (00000156)=0.132267186561690E+02 gamma(00000156)=0.132267186561690E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 156 z1= 1 -.595887108198377E-02 0.000000000000000E+00 z1= 2 -.257506010035990E-06 0.000000000000000E+00 z1= 3 -.114609846127434E-07 0.000000000000000E+00 alpha(00000156)=0.000000000000000E+00 beta (00000157)=0.125236520403996E+02 gamma(00000157)=0.125236520403996E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 157 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000157)=0.000000000000000E+00 beta (00000158)=0.135215460771997E+02 gamma(00000158)=0.135215460771997E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 158 z1= 1 0.552077063107263E-02 0.000000000000000E+00 z1= 2 0.237530382392673E-06 0.000000000000000E+00 z1= 3 -.290523294484146E-08 0.000000000000000E+00 alpha(00000158)=0.000000000000000E+00 beta (00000159)=0.127881280413410E+02 gamma(00000159)=0.127881280413410E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 159 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000159)=0.000000000000000E+00 beta (00000160)=0.139485774701754E+02 gamma(00000160)=0.139485774701754E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 160 z1= 1 -.498082084104811E-02 0.000000000000000E+00 z1= 2 -.220859229613235E-06 0.000000000000000E+00 z1= 3 0.101318997341310E-07 0.000000000000000E+00 alpha(00000160)=0.000000000000000E+00 beta (00000161)=0.127763301423311E+02 gamma(00000161)=0.127763301423311E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 161 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000161)=0.000000000000000E+00 beta (00000162)=0.130878487597720E+02 gamma(00000162)=0.130878487597720E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 162 z1= 1 0.478116491525005E-02 0.000000000000000E+00 z1= 2 0.222267177423657E-06 0.000000000000000E+00 z1= 3 -.141142072968350E-07 0.000000000000000E+00 alpha(00000162)=0.000000000000000E+00 beta (00000163)=0.131378763717517E+02 gamma(00000163)=0.131378763717517E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 163 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000163)=0.000000000000000E+00 beta (00000164)=0.129852880539974E+02 gamma(00000164)=0.129852880539974E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 164 z1= 1 -.443843698245732E-02 0.000000000000000E+00 z1= 2 -.233422139752498E-06 0.000000000000000E+00 z1= 3 0.154256948464715E-07 0.000000000000000E+00 alpha(00000164)=0.000000000000000E+00 beta (00000165)=0.126250386528957E+02 gamma(00000165)=0.126250386528957E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 165 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000165)=0.000000000000000E+00 beta (00000166)=0.133717534841429E+02 gamma(00000166)=0.133717534841429E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 166 z1= 1 0.346206549095371E-02 0.000000000000000E+00 z1= 2 0.225920633775342E-06 0.000000000000000E+00 z1= 3 -.188708101983223E-07 0.000000000000000E+00 alpha(00000166)=0.000000000000000E+00 beta (00000167)=0.127608898069883E+02 gamma(00000167)=0.127608898069883E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 167 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000167)=0.000000000000000E+00 beta (00000168)=0.141892520647354E+02 gamma(00000168)=0.141892520647354E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 168 z1= 1 -.250644529844304E-02 0.000000000000000E+00 z1= 2 -.206008809599742E-06 0.000000000000000E+00 z1= 3 0.245354451668817E-07 0.000000000000000E+00 alpha(00000168)=0.000000000000000E+00 beta (00000169)=0.122983036982335E+02 gamma(00000169)=0.122983036982335E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 169 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000169)=0.000000000000000E+00 beta (00000170)=0.136209309165128E+02 gamma(00000170)=0.136209309165128E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 170 z1= 1 0.191507719763747E-02 0.000000000000000E+00 z1= 2 0.190528476156672E-06 0.000000000000000E+00 z1= 3 -.273105363471707E-07 0.000000000000000E+00 alpha(00000170)=0.000000000000000E+00 beta (00000171)=0.122697378892469E+02 gamma(00000171)=0.122697378892469E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 171 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000171)=0.000000000000000E+00 beta (00000172)=0.129523594858633E+02 gamma(00000172)=0.129523594858633E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 172 z1= 1 -.169678310478808E-02 0.000000000000000E+00 z1= 2 -.186556152249363E-06 0.000000000000000E+00 z1= 3 0.280176506274946E-07 0.000000000000000E+00 alpha(00000172)=0.000000000000000E+00 beta (00000173)=0.122351734730778E+02 gamma(00000173)=0.122351734730778E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 173 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000173)=0.000000000000000E+00 beta (00000174)=0.139756749392308E+02 gamma(00000174)=0.139756749392308E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 174 z1= 1 0.133513729432179E-02 0.000000000000000E+00 z1= 2 0.167412050135034E-06 0.000000000000000E+00 z1= 3 -.279692246680716E-07 0.000000000000000E+00 alpha(00000174)=0.000000000000000E+00 beta (00000175)=0.129307165911001E+02 gamma(00000175)=0.129307165911001E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 175 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000175)=0.000000000000000E+00 beta (00000176)=0.132725177598898E+02 gamma(00000176)=0.132725177598898E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 176 z1= 1 -.112922216006196E-02 0.000000000000000E+00 z1= 2 -.173163997704319E-06 0.000000000000000E+00 z1= 3 0.233977376111125E-07 0.000000000000000E+00 alpha(00000176)=0.000000000000000E+00 beta (00000177)=0.125054742590235E+02 gamma(00000177)=0.125054742590235E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 177 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000177)=0.000000000000000E+00 beta (00000178)=0.133813258461452E+02 gamma(00000178)=0.133813258461452E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 178 z1= 1 0.826292828128595E-03 0.000000000000000E+00 z1= 2 0.174990730100744E-06 0.000000000000000E+00 z1= 3 -.141087352972455E-07 0.000000000000000E+00 alpha(00000178)=0.000000000000000E+00 beta (00000179)=0.126357144645452E+02 gamma(00000179)=0.126357144645452E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 179 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000179)=0.000000000000000E+00 beta (00000180)=0.131777764544826E+02 gamma(00000180)=0.131777764544826E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 180 z1= 1 -.421363961365863E-03 0.000000000000000E+00 z1= 2 -.178064956165430E-06 0.000000000000000E+00 z1= 3 0.101776117551050E-07 0.000000000000000E+00 alpha(00000180)=0.000000000000000E+00 beta (00000181)=0.126295212538436E+02 gamma(00000181)=0.126295212538436E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 181 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000181)=0.000000000000000E+00 beta (00000182)=0.132336331950178E+02 gamma(00000182)=0.132336331950178E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 182 z1= 1 -.141099999292363E-03 0.000000000000000E+00 z1= 2 0.179410668223710E-06 0.000000000000000E+00 z1= 3 -.694100277774667E-08 0.000000000000000E+00 alpha(00000182)=0.000000000000000E+00 beta (00000183)=0.129114609847052E+02 gamma(00000183)=0.129114609847052E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 183 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000183)=0.000000000000000E+00 beta (00000184)=0.135800892666719E+02 gamma(00000184)=0.135800892666719E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 184 z1= 1 0.756151566905388E-03 0.000000000000000E+00 z1= 2 -.172711858288134E-06 0.000000000000000E+00 z1= 3 0.125931744320712E-07 0.000000000000000E+00 alpha(00000184)=0.000000000000000E+00 beta (00000185)=0.129480129098685E+02 gamma(00000185)=0.129480129098685E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 185 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000185)=0.000000000000000E+00 beta (00000186)=0.136308595107694E+02 gamma(00000186)=0.136308595107694E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 186 z1= 1 -.114706976845438E-02 0.000000000000000E+00 z1= 2 0.166707562429882E-06 0.000000000000000E+00 z1= 3 -.173644405200221E-07 0.000000000000000E+00 alpha(00000186)=0.000000000000000E+00 beta (00000187)=0.125086689387439E+02 gamma(00000187)=0.125086689387439E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 187 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000187)=0.000000000000000E+00 beta (00000188)=0.136340952142526E+02 gamma(00000188)=0.136340952142526E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 188 z1= 1 0.136069354868057E-02 0.000000000000000E+00 z1= 2 -.162260858924471E-06 0.000000000000000E+00 z1= 3 0.110632560300361E-07 0.000000000000000E+00 alpha(00000188)=0.000000000000000E+00 beta (00000189)=0.126286709338952E+02 gamma(00000189)=0.126286709338952E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 189 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000189)=0.000000000000000E+00 beta (00000190)=0.134171167522506E+02 gamma(00000190)=0.134171167522506E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 190 z1= 1 -.161830390363259E-02 0.000000000000000E+00 z1= 2 0.163544230168816E-06 0.000000000000000E+00 z1= 3 -.388028512012667E-08 0.000000000000000E+00 alpha(00000190)=0.000000000000000E+00 beta (00000191)=0.124710814395731E+02 gamma(00000191)=0.124710814395731E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 191 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000191)=0.000000000000000E+00 beta (00000192)=0.136215036426986E+02 gamma(00000192)=0.136215036426986E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 192 z1= 1 0.180517716196565E-02 0.000000000000000E+00 z1= 2 -.156833153715577E-06 0.000000000000000E+00 z1= 3 0.125103841695784E-08 0.000000000000000E+00 alpha(00000192)=0.000000000000000E+00 beta (00000193)=0.130478556176550E+02 gamma(00000193)=0.130478556176550E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 193 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000193)=0.000000000000000E+00 beta (00000194)=0.130881993724874E+02 gamma(00000194)=0.130881993724874E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 194 z1= 1 -.218370888223226E-02 0.000000000000000E+00 z1= 2 0.158937688050573E-06 0.000000000000000E+00 z1= 3 -.363272374074436E-08 0.000000000000000E+00 alpha(00000194)=0.000000000000000E+00 beta (00000195)=0.133222091059469E+02 gamma(00000195)=0.133222091059469E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 195 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000195)=0.000000000000000E+00 beta (00000196)=0.134810900585400E+02 gamma(00000196)=0.134810900585400E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 196 z1= 1 0.212245861074638E-02 0.000000000000000E+00 z1= 2 -.160250093326174E-06 0.000000000000000E+00 z1= 3 0.298265230135736E-08 0.000000000000000E+00 alpha(00000196)=0.000000000000000E+00 beta (00000197)=0.132472206233431E+02 gamma(00000197)=0.132472206233431E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 197 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000197)=0.000000000000000E+00 beta (00000198)=0.130644090474487E+02 gamma(00000198)=0.130644090474487E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 198 z1= 1 -.184140488637052E-02 0.000000000000000E+00 z1= 2 0.170399653004992E-06 0.000000000000000E+00 z1= 3 0.446966415702105E-08 0.000000000000000E+00 alpha(00000198)=0.000000000000000E+00 beta (00000199)=0.119855523398362E+02 gamma(00000199)=0.119855523398362E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 199 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000199)=0.000000000000000E+00 beta (00000200)=0.135632945603955E+02 gamma(00000200)=0.135632945603955E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 200 z1= 1 0.105283378301100E-02 0.000000000000000E+00 z1= 2 -.163567520548857E-06 0.000000000000000E+00 z1= 3 -.184538816432739E-07 0.000000000000000E+00 alpha(00000200)=0.000000000000000E+00 beta (00000201)=0.127088703662027E+02 gamma(00000201)=0.127088703662027E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 201 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000201)=0.000000000000000E+00 beta (00000202)=0.138555334340358E+02 gamma(00000202)=0.138555334340358E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 202 z1= 1 -.269612680881021E-03 0.000000000000000E+00 z1= 2 0.161304490905838E-06 0.000000000000000E+00 z1= 3 0.292922365074770E-07 0.000000000000000E+00 alpha(00000202)=0.000000000000000E+00 beta (00000203)=0.126095867039117E+02 gamma(00000203)=0.126095867039117E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 203 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000203)=0.000000000000000E+00 beta (00000204)=0.134126312050706E+02 gamma(00000204)=0.134126312050706E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 204 z1= 1 -.321662216179252E-03 0.000000000000000E+00 z1= 2 -.160627013057711E-06 0.000000000000000E+00 z1= 3 -.387415898142444E-07 0.000000000000000E+00 alpha(00000204)=0.000000000000000E+00 beta (00000205)=0.123936091569988E+02 gamma(00000205)=0.123936091569988E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 205 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000205)=0.000000000000000E+00 beta (00000206)=0.129976854723312E+02 gamma(00000206)=0.129976854723312E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 206 z1= 1 0.974379436941334E-03 0.000000000000000E+00 z1= 2 0.159983790545999E-06 0.000000000000000E+00 z1= 3 0.479602991635200E-07 0.000000000000000E+00 alpha(00000206)=0.000000000000000E+00 beta (00000207)=0.122480877608777E+02 gamma(00000207)=0.122480877608777E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 207 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000207)=0.000000000000000E+00 beta (00000208)=0.134240965566022E+02 gamma(00000208)=0.134240965566022E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 208 z1= 1 -.164568786638559E-02 0.000000000000000E+00 z1= 2 -.151691818417975E-06 0.000000000000000E+00 z1= 3 -.525979403222070E-07 0.000000000000000E+00 alpha(00000208)=0.000000000000000E+00 beta (00000209)=0.126747675859068E+02 gamma(00000209)=0.126747675859068E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 209 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000209)=0.000000000000000E+00 beta (00000210)=0.134540285408027E+02 gamma(00000210)=0.134540285408027E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 210 z1= 1 0.281906604343775E-02 0.000000000000000E+00 z1= 2 0.159413434854504E-06 0.000000000000000E+00 z1= 3 0.713810886956816E-07 0.000000000000000E+00 alpha(00000210)=0.000000000000000E+00 beta (00000211)=0.123270999772809E+02 gamma(00000211)=0.123270999772809E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 211 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000211)=0.000000000000000E+00 beta (00000212)=0.129888489019112E+02 gamma(00000212)=0.129888489019112E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 212 z1= 1 -.388855786986264E-02 0.000000000000000E+00 z1= 2 -.174940323103591E-06 0.000000000000000E+00 z1= 3 -.975215149671797E-07 0.000000000000000E+00 alpha(00000212)=0.000000000000000E+00 beta (00000213)=0.130784544754399E+02 gamma(00000213)=0.130784544754399E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 213 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000213)=0.000000000000000E+00 beta (00000214)=0.133370733161078E+02 gamma(00000214)=0.133370733161078E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 214 z1= 1 0.442277430685825E-02 0.000000000000000E+00 z1= 2 0.195045000994827E-06 0.000000000000000E+00 z1= 3 0.123455270082794E-06 0.000000000000000E+00 alpha(00000214)=0.000000000000000E+00 beta (00000215)=0.122604413714281E+02 gamma(00000215)=0.122604413714281E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 215 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000215)=0.000000000000000E+00 beta (00000216)=0.135149442087275E+02 gamma(00000216)=0.135149442087275E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 216 z1= 1 -.413641918814222E-02 0.000000000000000E+00 z1= 2 -.190303913739399E-06 0.000000000000000E+00 z1= 3 -.123961551863182E-06 0.000000000000000E+00 alpha(00000216)=0.000000000000000E+00 beta (00000217)=0.130597401107520E+02 gamma(00000217)=0.130597401107520E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 217 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000217)=0.000000000000000E+00 beta (00000218)=0.134738744434537E+02 gamma(00000218)=0.134738744434537E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 218 z1= 1 0.364132504929118E-02 0.000000000000000E+00 z1= 2 0.189205352502629E-06 0.000000000000000E+00 z1= 3 0.119041975787677E-06 0.000000000000000E+00 alpha(00000218)=0.000000000000000E+00 beta (00000219)=0.123569725096028E+02 gamma(00000219)=0.123569725096028E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 219 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000219)=0.000000000000000E+00 beta (00000220)=0.139261583761242E+02 gamma(00000220)=0.139261583761242E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 220 z1= 1 -.264216198051635E-02 0.000000000000000E+00 z1= 2 -.173589903395242E-06 0.000000000000000E+00 z1= 3 -.104633603018912E-06 0.000000000000000E+00 alpha(00000220)=0.000000000000000E+00 beta (00000221)=0.127827361039058E+02 gamma(00000221)=0.127827361039058E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 221 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000221)=0.000000000000000E+00 beta (00000222)=0.132363284258515E+02 gamma(00000222)=0.132363284258515E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 222 z1= 1 0.182434413200593E-02 0.000000000000000E+00 z1= 2 0.166557406014369E-06 0.000000000000000E+00 z1= 3 0.876181041023667E-07 0.000000000000000E+00 alpha(00000222)=0.000000000000000E+00 beta (00000223)=0.126638484572185E+02 gamma(00000223)=0.126638484572185E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 223 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000223)=0.000000000000000E+00 beta (00000224)=0.133440129493833E+02 gamma(00000224)=0.133440129493833E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 224 z1= 1 -.101407346053718E-02 0.000000000000000E+00 z1= 2 -.153339084619456E-06 0.000000000000000E+00 z1= 3 -.638820782821771E-07 0.000000000000000E+00 alpha(00000224)=0.000000000000000E+00 beta (00000225)=0.129139441970765E+02 gamma(00000225)=0.129139441970765E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 225 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000225)=0.000000000000000E+00 beta (00000226)=0.135823730957833E+02 gamma(00000226)=0.135823730957833E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 226 z1= 1 0.366220490868444E-03 0.000000000000000E+00 z1= 2 0.144687187854028E-06 0.000000000000000E+00 z1= 3 0.472020926546579E-07 0.000000000000000E+00 alpha(00000226)=0.000000000000000E+00 beta (00000227)=0.126079346351411E+02 gamma(00000227)=0.126079346351411E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 227 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000227)=0.000000000000000E+00 beta (00000228)=0.134590203809110E+02 gamma(00000228)=0.134590203809110E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 228 z1= 1 0.425724358352050E-03 0.000000000000000E+00 z1= 2 -.134016373880708E-06 0.000000000000000E+00 z1= 3 -.291118150384795E-07 0.000000000000000E+00 alpha(00000228)=0.000000000000000E+00 beta (00000229)=0.126354580640785E+02 gamma(00000229)=0.126354580640785E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 229 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000229)=0.000000000000000E+00 beta (00000230)=0.132693325770738E+02 gamma(00000230)=0.132693325770738E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 230 z1= 1 -.127851492225515E-02 0.000000000000000E+00 z1= 2 0.130023265973445E-06 0.000000000000000E+00 z1= 3 0.213563246167364E-07 0.000000000000000E+00 alpha(00000230)=0.000000000000000E+00 beta (00000231)=0.128192370286248E+02 gamma(00000231)=0.128192370286248E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 231 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000231)=0.000000000000000E+00 beta (00000232)=0.131443062620730E+02 gamma(00000232)=0.131443062620730E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 232 z1= 1 0.213926550206980E-02 0.000000000000000E+00 z1= 2 -.133333888131804E-06 0.000000000000000E+00 z1= 3 -.221559926347377E-07 0.000000000000000E+00 alpha(00000232)=0.000000000000000E+00 beta (00000233)=0.117134998183595E+02 gamma(00000233)=0.117134998183595E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 233 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000233)=0.000000000000000E+00 beta (00000234)=0.134181408517434E+02 gamma(00000234)=0.134181408517434E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 234 z1= 1 -.300842485651794E-02 0.000000000000000E+00 z1= 2 0.121320895181583E-06 0.000000000000000E+00 z1= 3 0.200597625962286E-07 0.000000000000000E+00 alpha(00000234)=0.000000000000000E+00 beta (00000235)=0.127029974250517E+02 gamma(00000235)=0.127029974250517E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 235 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000235)=0.000000000000000E+00 beta (00000236)=0.131889501113129E+02 gamma(00000236)=0.131889501113129E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 236 z1= 1 0.368972084365047E-02 0.000000000000000E+00 z1= 2 -.126877160331381E-06 0.000000000000000E+00 z1= 3 -.285742657308956E-07 0.000000000000000E+00 alpha(00000236)=0.000000000000000E+00 beta (00000237)=0.130424589826951E+02 gamma(00000237)=0.130424589826951E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 237 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000237)=0.000000000000000E+00 beta (00000238)=0.136080433287332E+02 gamma(00000238)=0.136080433287332E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 238 z1= 1 -.399887315725560E-02 0.000000000000000E+00 z1= 2 0.132920507156520E-06 0.000000000000000E+00 z1= 3 0.388512370378367E-07 0.000000000000000E+00 alpha(00000238)=0.000000000000000E+00 beta (00000239)=0.127357063969018E+02 gamma(00000239)=0.127357063969018E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 239 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000239)=0.000000000000000E+00 beta (00000240)=0.139160000253930E+02 gamma(00000240)=0.139160000253930E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 240 z1= 1 0.414401939241749E-02 0.000000000000000E+00 z1= 2 -.129426864240757E-06 0.000000000000000E+00 z1= 3 -.408894660036511E-07 0.000000000000000E+00 alpha(00000240)=0.000000000000000E+00 beta (00000241)=0.129912822807421E+02 gamma(00000241)=0.129912822807421E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 241 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000241)=0.000000000000000E+00 beta (00000242)=0.135235883185392E+02 gamma(00000242)=0.135235883185392E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 242 z1= 1 -.423843898806010E-02 0.000000000000000E+00 z1= 2 0.135515903723019E-06 0.000000000000000E+00 z1= 3 0.510216650773283E-07 0.000000000000000E+00 alpha(00000242)=0.000000000000000E+00 beta (00000243)=0.129327810867922E+02 gamma(00000243)=0.129327810867922E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 243 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000243)=0.000000000000000E+00 beta (00000244)=0.132305689721157E+02 gamma(00000244)=0.132305689721157E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 244 z1= 1 0.419039588397356E-02 0.000000000000000E+00 z1= 2 -.152144622129601E-06 0.000000000000000E+00 z1= 3 -.748633082665352E-07 0.000000000000000E+00 alpha(00000244)=0.000000000000000E+00 beta (00000245)=0.126386917945130E+02 gamma(00000245)=0.126386917945130E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 245 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000245)=0.000000000000000E+00 beta (00000246)=0.135992477728654E+02 gamma(00000246)=0.135992477728654E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 246 z1= 1 -.393031021480618E-02 0.000000000000000E+00 z1= 2 0.162265373670253E-06 0.000000000000000E+00 z1= 3 0.966687268245600E-07 0.000000000000000E+00 alpha(00000246)=0.000000000000000E+00 beta (00000247)=0.128188998460452E+02 gamma(00000247)=0.128188998460452E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 247 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000247)=0.000000000000000E+00 beta (00000248)=0.131440859782383E+02 gamma(00000248)=0.131440859782383E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 248 z1= 1 0.384415804919441E-02 0.000000000000000E+00 z1= 2 -.175349793851698E-06 0.000000000000000E+00 z1= 3 -.114650025985572E-06 0.000000000000000E+00 alpha(00000248)=0.000000000000000E+00 beta (00000249)=0.123936871519803E+02 gamma(00000249)=0.123936871519803E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 249 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000249)=0.000000000000000E+00 beta (00000250)=0.131791232869003E+02 gamma(00000250)=0.131791232869003E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 250 z1= 1 -.356726132595142E-02 0.000000000000000E+00 z1= 2 0.179243168267965E-06 0.000000000000000E+00 z1= 3 0.126305021094786E-06 0.000000000000000E+00 alpha(00000250)=0.000000000000000E+00 beta (00000251)=0.127446125882385E+02 gamma(00000251)=0.127446125882385E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 251 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000251)=0.000000000000000E+00 beta (00000252)=0.131600491893117E+02 gamma(00000252)=0.131600491893117E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 252 z1= 1 0.344840568874956E-02 0.000000000000000E+00 z1= 2 -.195316998929853E-06 0.000000000000000E+00 z1= 3 -.148081576413755E-06 0.000000000000000E+00 alpha(00000252)=0.000000000000000E+00 beta (00000253)=0.120942974207927E+02 gamma(00000253)=0.120942974207927E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 253 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000253)=0.000000000000000E+00 beta (00000254)=0.130884900932771E+02 gamma(00000254)=0.130884900932771E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 254 z1= 1 -.332401925599166E-02 0.000000000000000E+00 z1= 2 0.205255608538759E-06 0.000000000000000E+00 z1= 3 0.168615604709613E-06 0.000000000000000E+00 alpha(00000254)=0.000000000000000E+00 beta (00000255)=0.122949787199924E+02 gamma(00000255)=0.122949787199924E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 255 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000255)=0.000000000000000E+00 beta (00000256)=0.133715019727220E+02 gamma(00000256)=0.133715019727220E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 256 z1= 1 0.309772905880544E-02 0.000000000000000E+00 z1= 2 -.213200638623113E-06 0.000000000000000E+00 z1= 3 -.187628573281983E-06 0.000000000000000E+00 alpha(00000256)=0.000000000000000E+00 beta (00000257)=0.126643105201166E+02 gamma(00000257)=0.126643105201166E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 257 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000257)=0.000000000000000E+00 beta (00000258)=0.133399981727419E+02 gamma(00000258)=0.133399981727419E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 258 z1= 1 -.303373536042647E-02 0.000000000000000E+00 z1= 2 0.221239399792860E-06 0.000000000000000E+00 z1= 3 0.202243772686427E-06 0.000000000000000E+00 alpha(00000258)=0.000000000000000E+00 beta (00000259)=0.127509066029440E+02 gamma(00000259)=0.127509066029440E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 259 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000259)=0.000000000000000E+00 beta (00000260)=0.139527187667296E+02 gamma(00000260)=0.139527187667296E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 260 z1= 1 0.310645945090587E-02 0.000000000000000E+00 z1= 2 -.216264056821479E-06 0.000000000000000E+00 z1= 3 -.202430443765628E-06 0.000000000000000E+00 alpha(00000260)=0.000000000000000E+00 beta (00000261)=0.124301995396544E+02 gamma(00000261)=0.124301995396544E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 261 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000261)=0.000000000000000E+00 beta (00000262)=0.133556349024421E+02 gamma(00000262)=0.133556349024421E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 262 z1= 1 -.326168244541666E-02 0.000000000000000E+00 z1= 2 0.220280677057979E-06 0.000000000000000E+00 z1= 3 0.212647096903273E-06 0.000000000000000E+00 alpha(00000262)=0.000000000000000E+00 beta (00000263)=0.132288207669118E+02 gamma(00000263)=0.132288207669118E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 263 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000263)=0.000000000000000E+00 beta (00000264)=0.133124751895659E+02 gamma(00000264)=0.133124751895659E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 264 z1= 1 0.359796470814330E-02 0.000000000000000E+00 z1= 2 -.240283262841010E-06 0.000000000000000E+00 z1= 3 -.241163293383372E-06 0.000000000000000E+00 alpha(00000264)=0.000000000000000E+00 beta (00000265)=0.127892313968889E+02 gamma(00000265)=0.127892313968889E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 265 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000265)=0.000000000000000E+00 beta (00000266)=0.131292668098885E+02 gamma(00000266)=0.131292668098885E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 266 z1= 1 -.364978161003489E-02 0.000000000000000E+00 z1= 2 0.253719310421962E-06 0.000000000000000E+00 z1= 3 0.263819163320422E-06 0.000000000000000E+00 alpha(00000266)=0.000000000000000E+00 beta (00000267)=0.123433190451709E+02 gamma(00000267)=0.123433190451709E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 267 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000267)=0.000000000000000E+00 beta (00000268)=0.133992197930973E+02 gamma(00000268)=0.133992197930973E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 268 z1= 1 0.355413604406554E-02 0.000000000000000E+00 z1= 2 -.251903938439449E-06 0.000000000000000E+00 z1= 3 -.268178569310697E-06 0.000000000000000E+00 alpha(00000268)=0.000000000000000E+00 beta (00000269)=0.122540220333363E+02 gamma(00000269)=0.122540220333363E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 269 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000269)=0.000000000000000E+00 beta (00000270)=0.138495024534519E+02 gamma(00000270)=0.138495024534519E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 270 z1= 1 -.332259975102085E-02 0.000000000000000E+00 z1= 2 0.240736306945412E-06 0.000000000000000E+00 z1= 3 0.260589884220870E-06 0.000000000000000E+00 alpha(00000270)=0.000000000000000E+00 beta (00000271)=0.126404612713024E+02 gamma(00000271)=0.126404612713024E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 271 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000271)=0.000000000000000E+00 beta (00000272)=0.127758988738641E+02 gamma(00000272)=0.127758988738641E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 272 z1= 1 0.350763085442639E-02 0.000000000000000E+00 z1= 2 -.255999690486862E-06 0.000000000000000E+00 z1= 3 -.284349499303331E-06 0.000000000000000E+00 alpha(00000272)=0.000000000000000E+00 beta (00000273)=0.130373790467670E+02 gamma(00000273)=0.130373790467670E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 273 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000273)=0.000000000000000E+00 beta (00000274)=0.133052044973601E+02 gamma(00000274)=0.133052044973601E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 274 z1= 1 -.365675684167750E-02 0.000000000000000E+00 z1= 2 0.263282595703695E-06 0.000000000000000E+00 z1= 3 0.299018032097129E-06 0.000000000000000E+00 alpha(00000274)=0.000000000000000E+00 beta (00000275)=0.120070833894271E+02 gamma(00000275)=0.120070833894271E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 275 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000275)=0.000000000000000E+00 beta (00000276)=0.134357684472869E+02 gamma(00000276)=0.134357684472869E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 276 z1= 1 0.340642068344753E-02 0.000000000000000E+00 z1= 2 -.243280873043171E-06 0.000000000000000E+00 z1= 3 -.281564422320059E-06 0.000000000000000E+00 alpha(00000276)=0.000000000000000E+00 beta (00000277)=0.124719741657543E+02 gamma(00000277)=0.124719741657543E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 277 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000277)=0.000000000000000E+00 beta (00000278)=0.139892672797048E+02 gamma(00000278)=0.139892672797048E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 278 z1= 1 -.295150189691869E-02 0.000000000000000E+00 z1= 2 0.227437706857517E-06 0.000000000000000E+00 z1= 3 0.264122590809285E-06 0.000000000000000E+00 alpha(00000278)=0.000000000000000E+00 beta (00000279)=0.123300855662469E+02 gamma(00000279)=0.123300855662469E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 279 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000279)=0.000000000000000E+00 beta (00000280)=0.130515956681770E+02 gamma(00000280)=0.130515956681770E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 280 z1= 1 0.300532476360253E-02 0.000000000000000E+00 z1= 2 -.224606013827285E-06 0.000000000000000E+00 z1= 3 -.261571470386518E-06 0.000000000000000E+00 alpha(00000280)=0.000000000000000E+00 beta (00000281)=0.131138538289450E+02 gamma(00000281)=0.131138538289450E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 281 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000281)=0.000000000000000E+00 beta (00000282)=0.137452340304049E+02 gamma(00000282)=0.137452340304049E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 282 z1= 1 -.295113932305544E-02 0.000000000000000E+00 z1= 2 0.226011646098888E-06 0.000000000000000E+00 z1= 3 0.263860386393554E-06 0.000000000000000E+00 alpha(00000282)=0.000000000000000E+00 beta (00000283)=0.122835025536134E+02 gamma(00000283)=0.122835025536134E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 283 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000283)=0.000000000000000E+00 beta (00000284)=0.130404052698648E+02 gamma(00000284)=0.130404052698648E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 284 z1= 1 0.290275766232077E-02 0.000000000000000E+00 z1= 2 -.221581354448424E-06 0.000000000000000E+00 z1= 3 -.263215294495252E-06 0.000000000000000E+00 alpha(00000284)=0.000000000000000E+00 beta (00000285)=0.127521399848820E+02 gamma(00000285)=0.127521399848820E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 285 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000285)=0.000000000000000E+00 beta (00000286)=0.136893379564957E+02 gamma(00000286)=0.136893379564957E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 286 z1= 1 -.294582128759674E-02 0.000000000000000E+00 z1= 2 0.213691219312900E-06 0.000000000000000E+00 z1= 3 0.255587662504166E-06 0.000000000000000E+00 alpha(00000286)=0.000000000000000E+00 beta (00000287)=0.124622358922274E+02 gamma(00000287)=0.124622358922274E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 287 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000287)=0.000000000000000E+00 beta (00000288)=0.131294732235245E+02 gamma(00000288)=0.131294732235245E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 288 z1= 1 0.289134800284432E-02 0.000000000000000E+00 z1= 2 -.212844486865071E-06 0.000000000000000E+00 z1= 3 -.260715480526145E-06 0.000000000000000E+00 alpha(00000288)=0.000000000000000E+00 beta (00000289)=0.122919851226779E+02 gamma(00000289)=0.122919851226779E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 289 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000289)=0.000000000000000E+00 beta (00000290)=0.136579671255073E+02 gamma(00000290)=0.136579671255073E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 290 z1= 1 -.270173079045317E-02 0.000000000000000E+00 z1= 2 0.197951352138518E-06 0.000000000000000E+00 z1= 3 0.242609040351479E-06 0.000000000000000E+00 alpha(00000290)=0.000000000000000E+00 beta (00000291)=0.125955664930386E+02 gamma(00000291)=0.125955664930386E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 291 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000291)=0.000000000000000E+00 beta (00000292)=0.133899367966364E+02 gamma(00000292)=0.133899367966364E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 292 z1= 1 0.264551369078301E-02 0.000000000000000E+00 z1= 2 -.183663353783099E-06 0.000000000000000E+00 z1= 3 -.232771020420002E-06 0.000000000000000E+00 alpha(00000292)=0.000000000000000E+00 beta (00000293)=0.127983513191303E+02 gamma(00000293)=0.127983513191303E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 293 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000293)=0.000000000000000E+00 beta (00000294)=0.131707002047158E+02 gamma(00000294)=0.131707002047158E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 294 z1= 1 -.244224387400916E-02 0.000000000000000E+00 z1= 2 0.180771128951073E-06 0.000000000000000E+00 z1= 3 0.226787732205726E-06 0.000000000000000E+00 alpha(00000294)=0.000000000000000E+00 beta (00000295)=0.123373895182528E+02 gamma(00000295)=0.123373895182528E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 295 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000295)=0.000000000000000E+00 beta (00000296)=0.133788927271321E+02 gamma(00000296)=0.133788927271321E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 296 z1= 1 0.203845326739957E-02 0.000000000000000E+00 z1= 2 -.171219593618445E-06 0.000000000000000E+00 z1= 3 -.225205716778429E-06 0.000000000000000E+00 alpha(00000296)=0.000000000000000E+00 beta (00000297)=0.128370723419566E+02 gamma(00000297)=0.128370723419566E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 297 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000297)=0.000000000000000E+00 beta (00000298)=0.133595394800110E+02 gamma(00000298)=0.133595394800110E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 298 z1= 1 -.198381319451157E-02 0.000000000000000E+00 z1= 2 0.178831427882472E-06 0.000000000000000E+00 z1= 3 0.226993712070835E-06 0.000000000000000E+00 alpha(00000298)=0.000000000000000E+00 beta (00000299)=0.123759093387933E+02 gamma(00000299)=0.123759093387933E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 299 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000299)=0.000000000000000E+00 beta (00000300)=0.131839930233843E+02 gamma(00000300)=0.131839930233843E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 300 z1= 1 0.213117794819210E-02 0.000000000000000E+00 z1= 2 -.158829529592255E-06 0.000000000000000E+00 z1= 3 -.215371802347831E-06 0.000000000000000E+00 alpha(00000300)=0.000000000000000E+00 beta (00000301)=0.122038632461283E+02 gamma(00000301)=0.122038632461283E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 301 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000301)=0.000000000000000E+00 beta (00000302)=0.141144796121155E+02 gamma(00000302)=0.141144796121155E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 302 z1= 1 -.226020289157571E-02 0.000000000000000E+00 z1= 2 0.141733353332648E-06 0.000000000000000E+00 z1= 3 0.171945131895038E-06 0.000000000000000E+00 alpha(00000302)=0.000000000000000E+00 beta (00000303)=0.131773965866200E+02 gamma(00000303)=0.131773965866200E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 303 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000303)=0.000000000000000E+00 beta (00000304)=0.138341501941771E+02 gamma(00000304)=0.138341501941771E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 304 z1= 1 0.246840203764879E-02 0.000000000000000E+00 z1= 2 -.119383243956566E-06 0.000000000000000E+00 z1= 3 -.166286564448614E-06 0.000000000000000E+00 alpha(00000304)=0.000000000000000E+00 beta (00000305)=0.122220651176523E+02 gamma(00000305)=0.122220651176523E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 305 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000305)=0.000000000000000E+00 beta (00000306)=0.137057414681100E+02 gamma(00000306)=0.137057414681100E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 306 z1= 1 -.228412078410186E-02 0.000000000000000E+00 z1= 2 0.122148080682017E-06 0.000000000000000E+00 z1= 3 0.147949838829589E-06 0.000000000000000E+00 alpha(00000306)=0.000000000000000E+00 beta (00000307)=0.128785281876495E+02 gamma(00000307)=0.128785281876495E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 307 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000307)=0.000000000000000E+00 beta (00000308)=0.131093187039224E+02 gamma(00000308)=0.131093187039224E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 308 z1= 1 0.236424915001334E-02 0.000000000000000E+00 z1= 2 -.106825640718055E-06 0.000000000000000E+00 z1= 3 -.152476199331820E-06 0.000000000000000E+00 alpha(00000308)=0.000000000000000E+00 beta (00000309)=0.125899612224322E+02 gamma(00000309)=0.125899612224322E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 309 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000309)=0.000000000000000E+00 beta (00000310)=0.132665116191064E+02 gamma(00000310)=0.132665116191064E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 310 z1= 1 -.260524067781205E-02 0.000000000000000E+00 z1= 2 0.113333341829336E-06 0.000000000000000E+00 z1= 3 0.133383834143431E-06 0.000000000000000E+00 alpha(00000310)=0.000000000000000E+00 beta (00000311)=0.124599320370446E+02 gamma(00000311)=0.124599320370446E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 311 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000311)=0.000000000000000E+00 beta (00000312)=0.125070979725464E+02 gamma(00000312)=0.125070979725464E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 312 z1= 1 0.280838506684921E-02 0.000000000000000E+00 z1= 2 -.913169587713186E-07 0.000000000000000E+00 z1= 3 -.137808812495049E-06 0.000000000000000E+00 alpha(00000312)=0.000000000000000E+00 beta (00000313)=0.128876861642680E+02 gamma(00000313)=0.128876861642680E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 313 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000313)=0.000000000000000E+00 beta (00000314)=0.136193735042566E+02 gamma(00000314)=0.136193735042566E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 314 z1= 1 -.290849332711784E-02 0.000000000000000E+00 z1= 2 0.105851805059457E-06 0.000000000000000E+00 z1= 3 0.108915293016475E-06 0.000000000000000E+00 alpha(00000314)=0.000000000000000E+00 beta (00000315)=0.128629159429810E+02 gamma(00000315)=0.128629159429810E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 315 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000315)=0.000000000000000E+00 beta (00000316)=0.138218047213948E+02 gamma(00000316)=0.138218047213948E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 316 z1= 1 0.277093096028576E-02 0.000000000000000E+00 z1= 2 -.647513413989595E-07 0.000000000000000E+00 z1= 3 -.118204147694749E-06 0.000000000000000E+00 alpha(00000316)=0.000000000000000E+00 beta (00000317)=0.131469252374637E+02 gamma(00000317)=0.131469252374637E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 317 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000317)=0.000000000000000E+00 beta (00000318)=0.134866404208142E+02 gamma(00000318)=0.134866404208142E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 318 z1= 1 -.261398162465855E-02 0.000000000000000E+00 z1= 2 0.943856023123040E-07 0.000000000000000E+00 z1= 3 0.953119978247974E-07 0.000000000000000E+00 alpha(00000318)=0.000000000000000E+00 beta (00000319)=0.122028332677049E+02 gamma(00000319)=0.122028332677049E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 319 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000319)=0.000000000000000E+00 beta (00000320)=0.136568543204880E+02 gamma(00000320)=0.136568543204880E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 320 z1= 1 0.224455937043133E-02 0.000000000000000E+00 z1= 2 -.429210154944586E-07 0.000000000000000E+00 z1= 3 -.977479974607464E-07 0.000000000000000E+00 alpha(00000320)=0.000000000000000E+00 beta (00000321)=0.123161206977288E+02 gamma(00000321)=0.123161206977288E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 321 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000321)=0.000000000000000E+00 beta (00000322)=0.138333158441717E+02 gamma(00000322)=0.138333158441717E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 322 z1= 1 -.170204340744207E-02 0.000000000000000E+00 z1= 2 0.726061926084208E-07 0.000000000000000E+00 z1= 3 0.701993576390303E-07 0.000000000000000E+00 alpha(00000322)=0.000000000000000E+00 beta (00000323)=0.131747550035677E+02 gamma(00000323)=0.131747550035677E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 323 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000323)=0.000000000000000E+00 beta (00000324)=0.139798582479011E+02 gamma(00000324)=0.139798582479011E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 324 z1= 1 0.133745550827985E-02 0.000000000000000E+00 z1= 2 -.181709255577369E-07 0.000000000000000E+00 z1= 3 -.745983537415269E-07 0.000000000000000E+00 alpha(00000324)=0.000000000000000E+00 beta (00000325)=0.121142988839932E+02 gamma(00000325)=0.121142988839932E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 325 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000325)=0.000000000000000E+00 beta (00000326)=0.137455364329369E+02 gamma(00000326)=0.137455364329369E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 326 z1= 1 -.995307070191402E-03 0.000000000000000E+00 z1= 2 0.372884893514802E-07 0.000000000000000E+00 z1= 3 0.341927562808736E-07 0.000000000000000E+00 alpha(00000326)=0.000000000000000E+00 beta (00000327)=0.130084621357336E+02 gamma(00000327)=0.130084621357336E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 327 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000327)=0.000000000000000E+00 beta (00000328)=0.139730516521135E+02 gamma(00000328)=0.139730516521135E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 328 z1= 1 0.913911689147437E-03 0.000000000000000E+00 z1= 2 0.143136959262265E-08 0.000000000000000E+00 z1= 3 -.373805018678472E-07 0.000000000000000E+00 alpha(00000328)=0.000000000000000E+00 beta (00000329)=0.118215886185423E+02 gamma(00000329)=0.118215886185423E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 329 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000329)=0.000000000000000E+00 beta (00000330)=0.136355740754403E+02 gamma(00000330)=0.136355740754403E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 330 z1= 1 -.104547695216249E-02 0.000000000000000E+00 z1= 2 0.129960651924299E-08 0.000000000000000E+00 z1= 3 -.890726197715162E-09 0.000000000000000E+00 alpha(00000330)=0.000000000000000E+00 beta (00000331)=0.124186254903403E+02 gamma(00000331)=0.124186254903403E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 331 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000331)=0.000000000000000E+00 beta (00000332)=0.128634448899221E+02 gamma(00000332)=0.128634448899221E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 332 z1= 1 0.139916163703692E-02 0.000000000000000E+00 z1= 2 0.331296583256659E-07 0.000000000000000E+00 z1= 3 0.210584224787742E-07 0.000000000000000E+00 alpha(00000332)=0.000000000000000E+00 beta (00000333)=0.123177399349667E+02 gamma(00000333)=0.123177399349667E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 333 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000333)=0.000000000000000E+00 beta (00000334)=0.140295009387509E+02 gamma(00000334)=0.140295009387509E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 334 z1= 1 -.150908998836684E-02 0.000000000000000E+00 z1= 2 -.345666598513595E-07 0.000000000000000E+00 z1= 3 -.464899968991950E-07 0.000000000000000E+00 alpha(00000334)=0.000000000000000E+00 beta (00000335)=0.123868621391648E+02 gamma(00000335)=0.123868621391648E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 335 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000335)=0.000000000000000E+00 beta (00000336)=0.136372357197757E+02 gamma(00000336)=0.136372357197757E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 336 z1= 1 0.152110842359584E-02 0.000000000000000E+00 z1= 2 0.560672564294440E-07 0.000000000000000E+00 z1= 3 0.631491906434437E-07 0.000000000000000E+00 alpha(00000336)=0.000000000000000E+00 beta (00000337)=0.130454286350404E+02 gamma(00000337)=0.130454286350404E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 337 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000337)=0.000000000000000E+00 beta (00000338)=0.124748192540821E+02 gamma(00000338)=0.124748192540821E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 338 z1= 1 -.143569200573277E-02 0.000000000000000E+00 z1= 2 -.588184949519555E-07 0.000000000000000E+00 z1= 3 -.794015326011381E-07 0.000000000000000E+00 alpha(00000338)=0.000000000000000E+00 beta (00000339)=0.126901792941146E+02 gamma(00000339)=0.126901792941146E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 339 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000339)=0.000000000000000E+00 beta (00000340)=0.139949021415132E+02 gamma(00000340)=0.139949021415132E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 340 z1= 1 0.119234942980934E-02 0.000000000000000E+00 z1= 2 0.595212714578906E-07 0.000000000000000E+00 z1= 3 0.698510233454783E-07 0.000000000000000E+00 alpha(00000340)=0.000000000000000E+00 beta (00000341)=0.128392988521859E+02 gamma(00000341)=0.128392988521859E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 341 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000341)=0.000000000000000E+00 beta (00000342)=0.135381724674748E+02 gamma(00000342)=0.135381724674748E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 342 z1= 1 -.993664069280799E-03 0.000000000000000E+00 z1= 2 -.601317281128430E-07 0.000000000000000E+00 z1= 3 -.718273425578256E-07 0.000000000000000E+00 alpha(00000342)=0.000000000000000E+00 beta (00000343)=0.129252627560881E+02 gamma(00000343)=0.129252627560881E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 343 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000343)=0.000000000000000E+00 beta (00000344)=0.128890542982061E+02 gamma(00000344)=0.128890542982061E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 344 z1= 1 0.588151769862415E-03 0.000000000000000E+00 z1= 2 0.758659406554096E-07 0.000000000000000E+00 z1= 3 0.832863541143926E-07 0.000000000000000E+00 alpha(00000344)=0.000000000000000E+00 beta (00000345)=0.125925142427750E+02 gamma(00000345)=0.125925142427750E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 345 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000345)=0.000000000000000E+00 beta (00000346)=0.138589126439330E+02 gamma(00000346)=0.138589126439330E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 346 z1= 1 -.184522287376569E-03 0.000000000000000E+00 z1= 2 -.813979291211606E-07 0.000000000000000E+00 z1= 3 -.850649293914499E-07 0.000000000000000E+00 alpha(00000346)=0.000000000000000E+00 beta (00000347)=0.127108332410835E+02 gamma(00000347)=0.127108332410835E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 347 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000347)=0.000000000000000E+00 beta (00000348)=0.132925366024287E+02 gamma(00000348)=0.132925366024287E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 348 z1= 1 -.315114077186704E-03 0.000000000000000E+00 z1= 2 0.824912657070324E-07 0.000000000000000E+00 z1= 3 0.855629404452186E-07 0.000000000000000E+00 alpha(00000348)=0.000000000000000E+00 beta (00000349)=0.126863696498796E+02 gamma(00000349)=0.126863696498796E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 349 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000349)=0.000000000000000E+00 beta (00000350)=0.134119753213653E+02 gamma(00000350)=0.134119753213653E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 350 z1= 1 0.855985655133153E-03 0.000000000000000E+00 z1= 2 -.837109673107190E-07 0.000000000000000E+00 z1= 3 -.730428701223394E-07 0.000000000000000E+00 alpha(00000350)=0.000000000000000E+00 beta (00000351)=0.123494885337035E+02 gamma(00000351)=0.123494885337035E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 351 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000351)=0.000000000000000E+00 beta (00000352)=0.133992397019960E+02 gamma(00000352)=0.133992397019960E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 352 z1= 1 -.144480404178098E-02 0.000000000000000E+00 z1= 2 0.700565948914703E-07 0.000000000000000E+00 z1= 3 0.620989932786356E-07 0.000000000000000E+00 alpha(00000352)=0.000000000000000E+00 beta (00000353)=0.118181669316658E+02 gamma(00000353)=0.118181669316658E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 353 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000353)=0.000000000000000E+00 beta (00000354)=0.125673065127117E+02 gamma(00000354)=0.125673065127117E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 354 z1= 1 0.188785976326677E-02 0.000000000000000E+00 z1= 2 -.799100620215614E-07 0.000000000000000E+00 z1= 3 -.515988910564742E-07 0.000000000000000E+00 alpha(00000354)=0.000000000000000E+00 beta (00000355)=0.124081648154026E+02 gamma(00000355)=0.124081648154026E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 355 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000355)=0.000000000000000E+00 beta (00000356)=0.130851086603270E+02 gamma(00000356)=0.130851086603270E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 356 z1= 1 -.213028296888857E-02 0.000000000000000E+00 z1= 2 0.694159191310067E-07 0.000000000000000E+00 z1= 3 0.724118787481169E-07 0.000000000000000E+00 alpha(00000356)=0.000000000000000E+00 beta (00000357)=0.124726463502120E+02 gamma(00000357)=0.124726463502120E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 357 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000357)=0.000000000000000E+00 beta (00000358)=0.136595320027766E+02 gamma(00000358)=0.136595320027766E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 358 z1= 1 0.230574098882517E-02 0.000000000000000E+00 z1= 2 -.924052120985066E-07 0.000000000000000E+00 z1= 3 -.472775982116513E-07 0.000000000000000E+00 alpha(00000358)=0.000000000000000E+00 beta (00000359)=0.127161787122671E+02 gamma(00000359)=0.127161787122671E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 359 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000359)=0.000000000000000E+00 beta (00000360)=0.141508501627600E+02 gamma(00000360)=0.141508501627600E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 360 z1= 1 -.221080925063832E-02 0.000000000000000E+00 z1= 2 0.420370798529250E-07 0.000000000000000E+00 z1= 3 0.611160981169988E-07 0.000000000000000E+00 alpha(00000360)=0.000000000000000E+00 beta (00000361)=0.123982547563937E+02 gamma(00000361)=0.123982547563937E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 361 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000361)=0.000000000000000E+00 beta (00000362)=0.136948885486652E+02 gamma(00000362)=0.136948885486652E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 362 z1= 1 0.182298062906670E-02 0.000000000000000E+00 z1= 2 -.837729520784336E-07 0.000000000000000E+00 z1= 3 -.229242607514509E-07 0.000000000000000E+00 alpha(00000362)=0.000000000000000E+00 beta (00000363)=0.120957540979345E+02 gamma(00000363)=0.120957540979345E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 363 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000363)=0.000000000000000E+00 beta (00000364)=0.137330622650823E+02 gamma(00000364)=0.137330622650823E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 364 z1= 1 -.126614574704741E-02 0.000000000000000E+00 z1= 2 0.210610694304425E-07 0.000000000000000E+00 z1= 3 0.525787225759433E-07 0.000000000000000E+00 alpha(00000364)=0.000000000000000E+00 beta (00000365)=0.130221301535821E+02 gamma(00000365)=0.130221301535821E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 365 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000365)=0.000000000000000E+00 beta (00000366)=0.136368913626403E+02 gamma(00000366)=0.136368913626403E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 366 z1= 1 0.636543625388076E-03 0.000000000000000E+00 z1= 2 -.873271987784485E-07 0.000000000000000E+00 z1= 3 -.199104507967048E-07 0.000000000000000E+00 alpha(00000366)=0.000000000000000E+00 beta (00000367)=0.128318841820523E+02 gamma(00000367)=0.128318841820523E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 367 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000367)=0.000000000000000E+00 beta (00000368)=0.129448537845110E+02 gamma(00000368)=0.129448537845110E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 368 z1= 1 0.130571166357735E-03 0.000000000000000E+00 z1= 2 0.269830532650690E-07 0.000000000000000E+00 z1= 3 0.734394645322128E-07 0.000000000000000E+00 alpha(00000368)=0.000000000000000E+00 beta (00000369)=0.124669635137200E+02 gamma(00000369)=0.124669635137200E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 369 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000369)=0.000000000000000E+00 beta (00000370)=0.134911169137474E+02 gamma(00000370)=0.134911169137474E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 370 z1= 1 -.567691840496737E-03 0.000000000000000E+00 z1= 2 -.104341606029065E-06 0.000000000000000E+00 z1= 3 -.439180577719743E-07 0.000000000000000E+00 alpha(00000370)=0.000000000000000E+00 beta (00000371)=0.122186562478649E+02 gamma(00000371)=0.122186562478649E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 371 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000371)=0.000000000000000E+00 beta (00000372)=0.133986280345231E+02 gamma(00000372)=0.133986280345231E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 372 z1= 1 0.114995980844131E-02 0.000000000000000E+00 z1= 2 0.874755444891639E-08 0.000000000000000E+00 z1= 3 0.102199563860317E-06 0.000000000000000E+00 alpha(00000372)=0.000000000000000E+00 beta (00000373)=0.127008879363638E+02 gamma(00000373)=0.127008879363638E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 373 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000373)=0.000000000000000E+00 beta (00000374)=0.129080368024131E+02 gamma(00000374)=0.129080368024131E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 374 z1= 1 -.198273307480085E-02 0.000000000000000E+00 z1= 2 -.130836036419009E-06 0.000000000000000E+00 z1= 3 -.330832640503629E-07 0.000000000000000E+00 alpha(00000374)=0.000000000000000E+00 beta (00000375)=0.125827902044064E+02 gamma(00000375)=0.125827902044064E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 375 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000375)=0.000000000000000E+00 beta (00000376)=0.134903933071056E+02 gamma(00000376)=0.134903933071056E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 376 z1= 1 0.272034471904654E-02 0.000000000000000E+00 z1= 2 -.434447745843768E-07 0.000000000000000E+00 z1= 3 0.131239624456456E-06 0.000000000000000E+00 alpha(00000376)=0.000000000000000E+00 beta (00000377)=0.124338294915637E+02 gamma(00000377)=0.124338294915637E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 377 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000377)=0.000000000000000E+00 beta (00000378)=0.135480797876250E+02 gamma(00000378)=0.135480797876250E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 378 z1= 1 -.329543257220598E-02 0.000000000000000E+00 z1= 2 -.194422631412958E-06 0.000000000000000E+00 z1= 3 0.193137148353333E-08 0.000000000000000E+00 alpha(00000378)=0.000000000000000E+00 beta (00000379)=0.123809985991011E+02 gamma(00000379)=0.123809985991011E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 379 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000379)=0.000000000000000E+00 beta (00000380)=0.137206518597933E+02 gamma(00000380)=0.137206518597933E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 380 z1= 1 0.339002412079985E-02 0.000000000000000E+00 z1= 2 -.129917705152726E-06 0.000000000000000E+00 z1= 3 0.171212343516450E-06 0.000000000000000E+00 alpha(00000380)=0.000000000000000E+00 beta (00000381)=0.124884719910528E+02 gamma(00000381)=0.124884719910528E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 381 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000381)=0.000000000000000E+00 beta (00000382)=0.126148912498447E+02 gamma(00000382)=0.126148912498447E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 382 z1= 1 -.359772646923629E-02 0.000000000000000E+00 z1= 2 -.295132280318626E-06 0.000000000000000E+00 z1= 3 0.786473084195749E-07 0.000000000000000E+00 alpha(00000382)=0.000000000000000E+00 beta (00000383)=0.127143978801261E+02 gamma(00000383)=0.127143978801261E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 383 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000383)=0.000000000000000E+00 beta (00000384)=0.138220789477076E+02 gamma(00000384)=0.138220789477076E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 384 z1= 1 0.332908334841912E-02 0.000000000000000E+00 z1= 2 -.313902015559300E-06 0.000000000000000E+00 z1= 3 0.236272485315916E-06 0.000000000000000E+00 alpha(00000384)=0.000000000000000E+00 beta (00000385)=0.124548442133635E+02 gamma(00000385)=0.124548442133635E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 385 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000385)=0.000000000000000E+00 beta (00000386)=0.140712971785472E+02 gamma(00000386)=0.140712971785472E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 386 z1= 1 -.280421288343640E-02 0.000000000000000E+00 z1= 2 -.466360410637497E-06 0.000000000000000E+00 z1= 3 0.212207579003659E-06 0.000000000000000E+00 alpha(00000386)=0.000000000000000E+00 beta (00000387)=0.129247355935121E+02 gamma(00000387)=0.129247355935121E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 387 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000387)=0.000000000000000E+00 beta (00000388)=0.141565683435678E+02 gamma(00000388)=0.141565683435678E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 388 z1= 1 0.239960236641539E-02 0.000000000000000E+00 z1= 2 -.403184001368994E-06 0.000000000000000E+00 z1= 3 0.248449776192529E-06 0.000000000000000E+00 alpha(00000388)=0.000000000000000E+00 beta (00000389)=0.122476092613822E+02 gamma(00000389)=0.122476092613822E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 389 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000389)=0.000000000000000E+00 beta (00000390)=0.130031182679316E+02 gamma(00000390)=0.130031182679316E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 390 z1= 1 -.229184616237578E-02 0.000000000000000E+00 z1= 2 -.418403261133113E-06 0.000000000000000E+00 z1= 3 0.214654581662103E-06 0.000000000000000E+00 alpha(00000390)=0.000000000000000E+00 beta (00000391)=0.137284786581637E+02 gamma(00000391)=0.137284786581637E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 391 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000391)=0.000000000000000E+00 beta (00000392)=0.133578238456993E+02 gamma(00000392)=0.133578238456993E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 392 z1= 1 0.249119814784060E-02 0.000000000000000E+00 z1= 2 -.332150104459918E-06 0.000000000000000E+00 z1= 3 0.183896993943052E-06 0.000000000000000E+00 alpha(00000392)=0.000000000000000E+00 beta (00000393)=0.126406043409374E+02 gamma(00000393)=0.126406043409374E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 393 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000393)=0.000000000000000E+00 beta (00000394)=0.130317156234349E+02 gamma(00000394)=0.130317156234349E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 394 z1= 1 -.250348832038345E-02 0.000000000000000E+00 z1= 2 -.301723836141059E-06 0.000000000000000E+00 z1= 3 0.163662497938092E-06 0.000000000000000E+00 alpha(00000394)=0.000000000000000E+00 beta (00000395)=0.133127934166841E+02 gamma(00000395)=0.133127934166841E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 395 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000395)=0.000000000000000E+00 beta (00000396)=0.135483562626023E+02 gamma(00000396)=0.135483562626023E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 396 z1= 1 0.252239216099825E-02 0.000000000000000E+00 z1= 2 -.218137697433280E-06 0.000000000000000E+00 z1= 3 0.990267478679589E-07 0.000000000000000E+00 alpha(00000396)=0.000000000000000E+00 beta (00000397)=0.115654759525866E+02 gamma(00000397)=0.115654759525866E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 397 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000397)=0.000000000000000E+00 beta (00000398)=0.143120225081840E+02 gamma(00000398)=0.143120225081840E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 398 z1= 1 -.203742837085640E-02 0.000000000000000E+00 z1= 2 -.203427871206833E-06 0.000000000000000E+00 z1= 3 0.102658565971810E-06 0.000000000000000E+00 alpha(00000398)=0.000000000000000E+00 beta (00000399)=0.131606075928856E+02 gamma(00000399)=0.131606075928856E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 399 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000399)=0.000000000000000E+00 beta (00000400)=0.133727973823862E+02 gamma(00000400)=0.133727973823862E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 400 z1= 1 0.198082367975960E-02 0.000000000000000E+00 z1= 2 -.122821041564133E-06 0.000000000000000E+00 z1= 3 0.226953662421474E-07 0.000000000000000E+00 alpha(00000400)=0.000000000000000E+00 beta (00000401)=0.123786393457965E+02 gamma(00000401)=0.123786393457965E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 401 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000401)=0.000000000000000E+00 beta (00000402)=0.132060810930627E+02 gamma(00000402)=0.132060810930627E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 402 z1= 1 -.185186238645900E-02 0.000000000000000E+00 z1= 2 -.577489118092252E-07 0.000000000000000E+00 z1= 3 0.536610939455041E-07 0.000000000000000E+00 alpha(00000402)=0.000000000000000E+00 beta (00000403)=0.123766163011787E+02 gamma(00000403)=0.123766163011787E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 403 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000403)=0.000000000000000E+00 beta (00000404)=0.134018778193632E+02 gamma(00000404)=0.134018778193632E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 404 z1= 1 0.181187214602018E-02 0.000000000000000E+00 z1= 2 -.277138965686964E-07 0.000000000000000E+00 z1= 3 -.742321127108602E-07 0.000000000000000E+00 alpha(00000404)=0.000000000000000E+00 beta (00000405)=0.125337822717033E+02 gamma(00000405)=0.125337822717033E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 405 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000405)=0.000000000000000E+00 beta (00000406)=0.136828117245877E+02 gamma(00000406)=0.136828117245877E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 406 z1= 1 -.147841613478346E-02 0.000000000000000E+00 z1= 2 0.547795660165405E-07 0.000000000000000E+00 z1= 3 0.185996639867191E-07 0.000000000000000E+00 alpha(00000406)=0.000000000000000E+00 beta (00000407)=0.122953167778759E+02 gamma(00000407)=0.122953167778759E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 407 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000407)=0.000000000000000E+00 beta (00000408)=0.130815631145905E+02 gamma(00000408)=0.130815631145905E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 408 z1= 1 0.947882147384856E-03 0.000000000000000E+00 z1= 2 0.543889474115874E-07 0.000000000000000E+00 z1= 3 -.173144754064217E-06 0.000000000000000E+00 alpha(00000408)=0.000000000000000E+00 beta (00000409)=0.128439467662655E+02 gamma(00000409)=0.128439467662655E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 409 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000409)=0.000000000000000E+00 beta (00000410)=0.135156651476747E+02 gamma(00000410)=0.135156651476747E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 410 z1= 1 -.625713929844631E-03 0.000000000000000E+00 z1= 2 0.149156864177316E-06 0.000000000000000E+00 z1= 3 -.646070058701875E-07 0.000000000000000E+00 alpha(00000410)=0.000000000000000E+00 beta (00000411)=0.121512352183307E+02 gamma(00000411)=0.121512352183307E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 411 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000411)=0.000000000000000E+00 beta (00000412)=0.135035808309933E+02 gamma(00000412)=0.135035808309933E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 412 z1= 1 0.295256489539564E-03 0.000000000000000E+00 z1= 2 0.180012938344421E-06 0.000000000000000E+00 z1= 3 -.271749444576315E-06 0.000000000000000E+00 alpha(00000412)=0.000000000000000E+00 beta (00000413)=0.129410311264263E+02 gamma(00000413)=0.129410311264263E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 413 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000413)=0.000000000000000E+00 beta (00000414)=0.129801756383169E+02 gamma(00000414)=0.129801756383169E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 414 z1= 1 -.863915628622055E-04 0.000000000000000E+00 z1= 2 0.287427050786083E-06 0.000000000000000E+00 z1= 3 -.167205199448715E-06 0.000000000000000E+00 alpha(00000414)=0.000000000000000E+00 beta (00000415)=0.121115267581769E+02 gamma(00000415)=0.121115267581769E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 415 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000415)=0.000000000000000E+00 beta (00000416)=0.134055547477702E+02 gamma(00000416)=0.134055547477702E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 416 z1= 1 0.563526272258710E-05 0.000000000000000E+00 z1= 2 0.374552755358446E-06 0.000000000000000E+00 z1= 3 -.463185991882945E-06 0.000000000000000E+00 alpha(00000416)=0.000000000000000E+00 beta (00000417)=0.128931384474369E+02 gamma(00000417)=0.128931384474369E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 417 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000417)=0.000000000000000E+00 beta (00000418)=0.127826630490255E+02 gamma(00000418)=0.127826630490255E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 418 z1= 1 -.160242060407345E-03 0.000000000000000E+00 z1= 2 0.579857650381387E-06 0.000000000000000E+00 z1= 3 -.424597885574337E-06 0.000000000000000E+00 alpha(00000418)=0.000000000000000E+00 beta (00000419)=0.129252521956085E+02 gamma(00000419)=0.129252521956085E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 419 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000419)=0.000000000000000E+00 beta (00000420)=0.132019450559241E+02 gamma(00000420)=0.132019450559241E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 420 z1= 1 0.298958968109727E-03 0.000000000000000E+00 z1= 2 0.744863744170810E-06 0.000000000000000E+00 z1= 3 -.797588693822069E-06 0.000000000000000E+00 alpha(00000420)=0.000000000000000E+00 beta (00000421)=0.121747907085748E+02 gamma(00000421)=0.121747907085748E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 421 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000421)=0.000000000000000E+00 beta (00000422)=0.132526697391373E+02 gamma(00000422)=0.132526697391373E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 422 z1= 1 -.325336056977075E-03 0.000000000000000E+00 z1= 2 0.112977896638390E-05 0.000000000000000E+00 z1= 3 -.978670373135045E-06 0.000000000000000E+00 alpha(00000422)=0.000000000000000E+00 beta (00000423)=0.127818872656598E+02 gamma(00000423)=0.127818872656598E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 423 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000423)=0.000000000000000E+00 beta (00000424)=0.134395978159719E+02 gamma(00000424)=0.134395978159719E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 424 z1= 1 0.152480444313794E-03 0.000000000000000E+00 z1= 2 0.153832914185801E-05 0.000000000000000E+00 z1= 3 -.149124706471391E-05 0.000000000000000E+00 alpha(00000424)=0.000000000000000E+00 beta (00000425)=0.129593776250921E+02 gamma(00000425)=0.129593776250921E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 425 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000425)=0.000000000000000E+00 beta (00000426)=0.131541475386758E+02 gamma(00000426)=0.131541475386758E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 426 z1= 1 -.390570433936224E-04 0.000000000000000E+00 z1= 2 0.189297182546979E-05 0.000000000000000E+00 z1= 3 -.170154510180875E-05 0.000000000000000E+00 alpha(00000426)=0.000000000000000E+00 beta (00000427)=0.128737801775129E+02 gamma(00000427)=0.128737801775129E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 427 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000427)=0.000000000000000E+00 beta (00000428)=0.139132398705434E+02 gamma(00000428)=0.139132398705434E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 428 z1= 1 0.787846732066269E-04 0.000000000000000E+00 z1= 2 0.220621813483424E-05 0.000000000000000E+00 z1= 3 -.206347440190346E-05 0.000000000000000E+00 alpha(00000428)=0.000000000000000E+00 beta (00000429)=0.130179571484911E+02 gamma(00000429)=0.130179571484911E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 429 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000429)=0.000000000000000E+00 beta (00000430)=0.131867006820962E+02 gamma(00000430)=0.131867006820962E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 430 z1= 1 -.334485631909672E-03 0.000000000000000E+00 z1= 2 0.209214420140730E-05 0.000000000000000E+00 z1= 3 -.192475479013745E-05 0.000000000000000E+00 alpha(00000430)=0.000000000000000E+00 beta (00000431)=0.121669799870315E+02 gamma(00000431)=0.121669799870315E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 431 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000431)=0.000000000000000E+00 beta (00000432)=0.137384246747876E+02 gamma(00000432)=0.137384246747876E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 432 z1= 1 0.881456710462220E-03 0.000000000000000E+00 z1= 2 0.237308430271104E-05 0.000000000000000E+00 z1= 3 -.214522573737936E-05 0.000000000000000E+00 alpha(00000432)=0.000000000000000E+00 beta (00000433)=0.134480046642476E+02 gamma(00000433)=0.134480046642476E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 433 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000433)=0.000000000000000E+00 beta (00000434)=0.136771883485663E+02 gamma(00000434)=0.136771883485663E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 434 z1= 1 -.152694585055883E-02 0.000000000000000E+00 z1= 2 0.202423157812884E-05 0.000000000000000E+00 z1= 3 -.189610126002330E-05 0.000000000000000E+00 alpha(00000434)=0.000000000000000E+00 beta (00000435)=0.122377675306842E+02 gamma(00000435)=0.122377675306842E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 435 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000435)=0.000000000000000E+00 beta (00000436)=0.134391791738847E+02 gamma(00000436)=0.134391791738847E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 436 z1= 1 0.189151380286160E-02 0.000000000000000E+00 z1= 2 0.181590183596318E-05 0.000000000000000E+00 z1= 3 -.155798622790350E-05 0.000000000000000E+00 alpha(00000436)=0.000000000000000E+00 beta (00000437)=0.122420604875299E+02 gamma(00000437)=0.122420604875299E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 437 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000437)=0.000000000000000E+00 beta (00000438)=0.140863744146255E+02 gamma(00000438)=0.140863744146255E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 438 z1= 1 -.196752470661491E-02 0.000000000000000E+00 z1= 2 0.157367938783109E-05 0.000000000000000E+00 z1= 3 -.148708017010048E-05 0.000000000000000E+00 alpha(00000438)=0.000000000000000E+00 beta (00000439)=0.121610379337055E+02 gamma(00000439)=0.121610379337055E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 439 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000439)=0.000000000000000E+00 beta (00000440)=0.134341569395065E+02 gamma(00000440)=0.134341569395065E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 440 z1= 1 0.208609127219030E-02 0.000000000000000E+00 z1= 2 0.160384009694880E-05 0.000000000000000E+00 z1= 3 -.124708763944215E-05 0.000000000000000E+00 alpha(00000440)=0.000000000000000E+00 beta (00000441)=0.124883731186286E+02 gamma(00000441)=0.124883731186286E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 441 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000441)=0.000000000000000E+00 beta (00000442)=0.131729843920689E+02 gamma(00000442)=0.131729843920689E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 442 z1= 1 -.222753829628454E-02 0.000000000000000E+00 z1= 2 0.150591296377289E-05 0.000000000000000E+00 z1= 3 -.144001685729736E-05 0.000000000000000E+00 alpha(00000442)=0.000000000000000E+00 beta (00000443)=0.132709775782051E+02 gamma(00000443)=0.132709775782051E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 443 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000443)=0.000000000000000E+00 beta (00000444)=0.139895132824127E+02 gamma(00000444)=0.139895132824127E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 444 z1= 1 0.253360317223938E-02 0.000000000000000E+00 z1= 2 0.163833206202326E-05 0.000000000000000E+00 z1= 3 -.115484758542910E-05 0.000000000000000E+00 alpha(00000444)=0.000000000000000E+00 beta (00000445)=0.127497078008710E+02 gamma(00000445)=0.127497078008710E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 445 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000445)=0.000000000000000E+00 beta (00000446)=0.134367999005754E+02 gamma(00000446)=0.134367999005754E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 446 z1= 1 -.281922590208935E-02 0.000000000000000E+00 z1= 2 0.108161170309529E-05 0.000000000000000E+00 z1= 3 -.104106588135399E-05 0.000000000000000E+00 alpha(00000446)=0.000000000000000E+00 beta (00000447)=0.125152989188645E+02 gamma(00000447)=0.125152989188645E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 447 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000447)=0.000000000000000E+00 beta (00000448)=0.132892616616970E+02 gamma(00000448)=0.132892616616970E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 448 z1= 1 0.274864718529720E-02 0.000000000000000E+00 z1= 2 0.102377471581554E-05 0.000000000000000E+00 z1= 3 -.544080744221964E-06 0.000000000000000E+00 alpha(00000448)=0.000000000000000E+00 beta (00000449)=0.129377552425048E+02 gamma(00000449)=0.129377552425048E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 449 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000449)=0.000000000000000E+00 beta (00000450)=0.134631997883587E+02 gamma(00000450)=0.134631997883587E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 450 z1= 1 -.255696684271890E-02 0.000000000000000E+00 z1= 2 0.520530331618845E-06 0.000000000000000E+00 z1= 3 -.492094444186787E-06 0.000000000000000E+00 alpha(00000450)=0.000000000000000E+00 beta (00000451)=0.133745780494803E+02 gamma(00000451)=0.133745780494803E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 451 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000451)=0.000000000000000E+00 beta (00000452)=0.130968330923332E+02 gamma(00000452)=0.130968330923332E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 452 z1= 1 0.224392979057944E-02 0.000000000000000E+00 z1= 2 0.426111056247951E-06 0.000000000000000E+00 z1= 3 0.524859635297852E-07 0.000000000000000E+00 alpha(00000452)=0.000000000000000E+00 beta (00000453)=0.127543234271161E+02 gamma(00000453)=0.127543234271161E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 453 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000453)=0.000000000000000E+00 beta (00000454)=0.136496756789749E+02 gamma(00000454)=0.136496756789749E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 454 z1= 1 -.140780907766333E-02 0.000000000000000E+00 z1= 2 -.196409391205014E-06 0.000000000000000E+00 z1= 3 0.135308896114482E-06 0.000000000000000E+00 alpha(00000454)=0.000000000000000E+00 beta (00000455)=0.124636075803156E+02 gamma(00000455)=0.124636075803156E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 455 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000455)=0.000000000000000E+00 beta (00000456)=0.128264879648464E+02 gamma(00000456)=0.128264879648464E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 456 z1= 1 0.591945511743612E-03 0.000000000000000E+00 z1= 2 -.288170023576145E-06 0.000000000000000E+00 z1= 3 0.717877337333764E-06 0.000000000000000E+00 alpha(00000456)=0.000000000000000E+00 beta (00000457)=0.118147051971506E+02 gamma(00000457)=0.118147051971506E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 457 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000457)=0.000000000000000E+00 beta (00000458)=0.132920051179452E+02 gamma(00000458)=0.132920051179452E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 458 z1= 1 0.945084308120623E-04 0.000000000000000E+00 z1= 2 -.110754238581310E-05 0.000000000000000E+00 z1= 3 0.111016301104468E-05 0.000000000000000E+00 alpha(00000458)=0.000000000000000E+00 beta (00000459)=0.131946498179311E+02 gamma(00000459)=0.131946498179311E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 459 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000459)=0.000000000000000E+00 beta (00000460)=0.134028564491246E+02 gamma(00000460)=0.134028564491246E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 460 z1= 1 -.568401271019025E-03 0.000000000000000E+00 z1= 2 -.129607521155966E-05 0.000000000000000E+00 z1= 3 0.184730440278393E-05 0.000000000000000E+00 alpha(00000460)=0.000000000000000E+00 beta (00000461)=0.131276925443546E+02 gamma(00000461)=0.131276925443546E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 461 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000461)=0.000000000000000E+00 beta (00000462)=0.137357279589479E+02 gamma(00000462)=0.137357279589479E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 462 z1= 1 0.111357246932261E-02 0.000000000000000E+00 z1= 2 -.182788739763479E-05 0.000000000000000E+00 z1= 3 0.189499734908668E-05 0.000000000000000E+00 alpha(00000462)=0.000000000000000E+00 beta (00000463)=0.129242899748796E+02 gamma(00000463)=0.129242899748796E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 463 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000463)=0.000000000000000E+00 beta (00000464)=0.136935769793257E+02 gamma(00000464)=0.136935769793257E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 464 z1= 1 -.176867799928200E-02 0.000000000000000E+00 z1= 2 -.150669601211130E-05 0.000000000000000E+00 z1= 3 0.203593866300545E-05 0.000000000000000E+00 alpha(00000464)=0.000000000000000E+00 beta (00000465)=0.121025513434042E+02 gamma(00000465)=0.121025513434042E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 465 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000465)=0.000000000000000E+00 beta (00000466)=0.134725786018430E+02 gamma(00000466)=0.134725786018430E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 466 z1= 1 0.219690682784835E-02 0.000000000000000E+00 z1= 2 -.182178504831232E-05 0.000000000000000E+00 z1= 3 0.186571283911346E-05 0.000000000000000E+00 alpha(00000466)=0.000000000000000E+00 beta (00000467)=0.132102064126301E+02 gamma(00000467)=0.132102064126301E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 467 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000467)=0.000000000000000E+00 beta (00000468)=0.138582685191616E+02 gamma(00000468)=0.138582685191616E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 468 z1= 1 -.256523737437772E-02 0.000000000000000E+00 z1= 2 -.141021032174816E-05 0.000000000000000E+00 z1= 3 0.189233336568345E-05 0.000000000000000E+00 alpha(00000468)=0.000000000000000E+00 beta (00000469)=0.133013230140097E+02 gamma(00000469)=0.133013230140097E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 469 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000469)=0.000000000000000E+00 beta (00000470)=0.131259150186643E+02 gamma(00000470)=0.131259150186643E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 470 z1= 1 0.297889270938548E-02 0.000000000000000E+00 z1= 2 -.114118710845120E-05 0.000000000000000E+00 z1= 3 0.107266878806916E-05 0.000000000000000E+00 alpha(00000470)=0.000000000000000E+00 beta (00000471)=0.117347612273979E+02 gamma(00000471)=0.117347612273979E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 471 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000471)=0.000000000000000E+00 beta (00000472)=0.133277730307370E+02 gamma(00000472)=0.133277730307370E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 472 z1= 1 -.272400371331461E-02 0.000000000000000E+00 z1= 2 -.548092602204939E-06 0.000000000000000E+00 z1= 3 0.862531237665748E-06 0.000000000000000E+00 alpha(00000472)=0.000000000000000E+00 beta (00000473)=0.128571930898505E+02 gamma(00000473)=0.128571930898505E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 473 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000473)=0.000000000000000E+00 beta (00000474)=0.135380097703527E+02 gamma(00000474)=0.135380097703527E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 474 z1= 1 0.267874583092852E-02 0.000000000000000E+00 z1= 2 -.516840251823299E-06 0.000000000000000E+00 z1= 3 0.412578959051255E-06 0.000000000000000E+00 alpha(00000474)=0.000000000000000E+00 beta (00000475)=0.127407884459723E+02 gamma(00000475)=0.127407884459723E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 475 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000475)=0.000000000000000E+00 beta (00000476)=0.127451487240082E+02 gamma(00000476)=0.127451487240082E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 476 z1= 1 -.293572214827319E-02 0.000000000000000E+00 z1= 2 -.307928201210075E-08 0.000000000000000E+00 z1= 3 0.225753696167074E-06 0.000000000000000E+00 alpha(00000476)=0.000000000000000E+00 beta (00000477)=0.125205586144051E+02 gamma(00000477)=0.125205586144051E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 477 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000477)=0.000000000000000E+00 beta (00000478)=0.137340489275360E+02 gamma(00000478)=0.137340489275360E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 478 z1= 1 0.287172529012512E-02 0.000000000000000E+00 z1= 2 0.230049073605791E-07 0.000000000000000E+00 z1= 3 -.173272548988166E-06 0.000000000000000E+00 alpha(00000478)=0.000000000000000E+00 beta (00000479)=0.119958045272507E+02 gamma(00000479)=0.119958045272507E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 479 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000479)=0.000000000000000E+00 beta (00000480)=0.124379941708465E+02 gamma(00000480)=0.124379941708465E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 480 z1= 1 -.308613931844392E-02 0.000000000000000E+00 z1= 2 0.545463150796593E-06 0.000000000000000E+00 z1= 3 -.407743664235238E-06 0.000000000000000E+00 alpha(00000480)=0.000000000000000E+00 beta (00000481)=0.125407461460110E+02 gamma(00000481)=0.125407461460110E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 481 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000481)=0.000000000000000E+00 beta (00000482)=0.137289791894501E+02 gamma(00000482)=0.137289791894501E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 482 z1= 1 0.309712420907417E-02 0.000000000000000E+00 z1= 2 0.766436502666178E-06 0.000000000000000E+00 z1= 3 -.910767468434957E-06 0.000000000000000E+00 alpha(00000482)=0.000000000000000E+00 beta (00000483)=0.124372308396502E+02 gamma(00000483)=0.124372308396502E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 483 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000483)=0.000000000000000E+00 beta (00000484)=0.136556398903763E+02 gamma(00000484)=0.136556398903763E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 484 z1= 1 -.301091059307729E-02 0.000000000000000E+00 z1= 2 0.133213652066472E-05 0.000000000000000E+00 z1= 3 -.127472244651657E-05 0.000000000000000E+00 alpha(00000484)=0.000000000000000E+00 beta (00000485)=0.122589904213876E+02 gamma(00000485)=0.122589904213876E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 485 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000485)=0.000000000000000E+00 beta (00000486)=0.132892131416156E+02 gamma(00000486)=0.132892131416156E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 486 z1= 1 0.302927215385313E-02 0.000000000000000E+00 z1= 2 0.170332930176861E-05 0.000000000000000E+00 z1= 3 -.189148039036980E-05 0.000000000000000E+00 alpha(00000486)=0.000000000000000E+00 beta (00000487)=0.125691958604445E+02 gamma(00000487)=0.125691958604445E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 487 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000487)=0.000000000000000E+00 beta (00000488)=0.138794963299012E+02 gamma(00000488)=0.138794963299012E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 488 z1= 1 -.323221146341134E-02 0.000000000000000E+00 z1= 2 0.245034671925680E-05 0.000000000000000E+00 z1= 3 -.248407717069157E-05 0.000000000000000E+00 alpha(00000488)=0.000000000000000E+00 beta (00000489)=0.124477102157502E+02 gamma(00000489)=0.124477102157502E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 489 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000489)=0.000000000000000E+00 beta (00000490)=0.133784783716494E+02 gamma(00000490)=0.133784783716494E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 490 z1= 1 0.368165524932577E-02 0.000000000000000E+00 z1= 2 0.289306094616469E-05 0.000000000000000E+00 z1= 3 -.311915916853317E-05 0.000000000000000E+00 alpha(00000490)=0.000000000000000E+00 beta (00000491)=0.132980770426956E+02 gamma(00000491)=0.132980770426956E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 491 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000491)=0.000000000000000E+00 beta (00000492)=0.128304626982993E+02 gamma(00000492)=0.128304626982993E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 492 z1= 1 -.470750495963046E-02 0.000000000000000E+00 z1= 2 0.340321741146938E-05 0.000000000000000E+00 z1= 3 -.349285022509076E-05 0.000000000000000E+00 alpha(00000492)=0.000000000000000E+00 beta (00000493)=0.122408955881925E+02 gamma(00000493)=0.122408955881925E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 493 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000493)=0.000000000000000E+00 beta (00000494)=0.132530200348274E+02 gamma(00000494)=0.132530200348274E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 494 z1= 1 0.524318698525274E-02 0.000000000000000E+00 z1= 2 0.442973151017169E-05 0.000000000000000E+00 z1= 3 -.474994525937237E-05 0.000000000000000E+00 alpha(00000494)=0.000000000000000E+00 beta (00000495)=0.126138732797056E+02 gamma(00000495)=0.126138732797056E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 495 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000495)=0.000000000000000E+00 beta (00000496)=0.138890798030256E+02 gamma(00000496)=0.138890798030256E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 496 z1= 1 -.559586086721692E-02 0.000000000000000E+00 z1= 2 0.589762859690493E-05 0.000000000000000E+00 z1= 3 -.615069057198015E-05 0.000000000000000E+00 alpha(00000496)=0.000000000000000E+00 beta (00000497)=0.127192847526999E+02 gamma(00000497)=0.127192847526999E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 497 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000497)=0.000000000000000E+00 beta (00000498)=0.130460564232792E+02 gamma(00000498)=0.130460564232792E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 498 z1= 1 0.637545855090445E-02 0.000000000000000E+00 z1= 2 0.678023974228425E-05 0.000000000000000E+00 z1= 3 -.724578348197040E-05 0.000000000000000E+00 alpha(00000498)=0.000000000000000E+00 beta (00000499)=0.126157433727335E+02 gamma(00000499)=0.126157433727335E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 499 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000499)=0.000000000000000E+00 beta (00000500)=0.131078750642226E+02 gamma(00000500)=0.131078750642226E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 500 z1= 1 -.699475262038430E-02 0.000000000000000E+00 z1= 2 0.882824080792547E-05 0.000000000000000E+00 z1= 3 -.926922370753157E-05 0.000000000000000E+00 alpha(00000500)=0.000000000000000E+00 beta (00000501)=0.128021710944204E+02 gamma(00000501)=0.128021710944204E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Norm of initial Lanczos vectors= 1.468999772040204 Starting Lanczos loop 2 Lanczos iteration: 1 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal alpha(00000001)=0.000000000000000E+00 beta (00000002)=0.183408549940291E+01 gamma(00000002)=0.183408549940291E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 2 z1= 1 -.206818291205620E-06 0.000000000000000E+00 z1= 2 0.990801114364036E+00 0.000000000000000E+00 z1= 3 -.431771720670830E-06 0.000000000000000E+00 alpha(00000002)=0.000000000000000E+00 beta (00000003)=0.572337706114327E+01 gamma(00000003)=0.572337706114327E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 3 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000003)=0.000000000000000E+00 beta (00000004)=0.138861133035339E+02 gamma(00000004)=0.138861133035339E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 4 z1= 1 0.551615228984621E-07 0.000000000000000E+00 z1= 2 -.330755125829323E+00 0.000000000000000E+00 z1= 3 0.160893425605983E-06 0.000000000000000E+00 alpha(00000004)=0.000000000000000E+00 beta (00000005)=0.123143154597767E+02 gamma(00000005)=0.123143154597767E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 5 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000005)=0.000000000000000E+00 beta (00000006)=0.137542235787056E+02 gamma(00000006)=0.137542235787056E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 6 z1= 1 -.345158993623942E-07 0.000000000000000E+00 z1= 2 0.266479159000157E+00 0.000000000000000E+00 z1= 3 -.145325775604633E-06 0.000000000000000E+00 alpha(00000006)=0.000000000000000E+00 beta (00000007)=0.126557996027815E+02 gamma(00000007)=0.126557996027815E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 7 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000007)=0.000000000000000E+00 beta (00000008)=0.134527254073460E+02 gamma(00000008)=0.134527254073460E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 8 z1= 1 0.337049915139290E-07 0.000000000000000E+00 z1= 2 -.233103951089381E+00 0.000000000000000E+00 z1= 3 0.151040886631638E-06 0.000000000000000E+00 alpha(00000008)=0.000000000000000E+00 beta (00000009)=0.127405134414804E+02 gamma(00000009)=0.127405134414804E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 9 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000009)=0.000000000000000E+00 beta (00000010)=0.134621132728144E+02 gamma(00000010)=0.134621132728144E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 10 z1= 1 -.386642705707888E-07 0.000000000000000E+00 z1= 2 0.208828185097703E+00 0.000000000000000E+00 z1= 3 -.161595931815871E-06 0.000000000000000E+00 alpha(00000010)=0.000000000000000E+00 beta (00000011)=0.127778329962482E+02 gamma(00000011)=0.127778329962482E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 11 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000011)=0.000000000000000E+00 beta (00000012)=0.135178858707397E+02 gamma(00000012)=0.135178858707397E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 12 z1= 1 0.381502692405750E-07 0.000000000000000E+00 z1= 2 -.188479793299705E+00 0.000000000000000E+00 z1= 3 0.165439711270754E-06 0.000000000000000E+00 alpha(00000012)=0.000000000000000E+00 beta (00000013)=0.127513451137813E+02 gamma(00000013)=0.127513451137813E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 13 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000013)=0.000000000000000E+00 beta (00000014)=0.134908021366435E+02 gamma(00000014)=0.134908021366435E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 14 z1= 1 -.291968082839940E-07 0.000000000000000E+00 z1= 2 0.170998709376234E+00 0.000000000000000E+00 z1= 3 -.160321003107693E-06 0.000000000000000E+00 alpha(00000014)=0.000000000000000E+00 beta (00000015)=0.127936768719452E+02 gamma(00000015)=0.127936768719452E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 15 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000015)=0.000000000000000E+00 beta (00000016)=0.135567109473952E+02 gamma(00000016)=0.135567109473952E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 16 z1= 1 0.161878780952779E-07 0.000000000000000E+00 z1= 2 -.155434298451837E+00 0.000000000000000E+00 z1= 3 0.149158267644068E-06 0.000000000000000E+00 alpha(00000016)=0.000000000000000E+00 beta (00000017)=0.127918120277683E+02 gamma(00000017)=0.127918120277683E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 17 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000017)=0.000000000000000E+00 beta (00000018)=0.133937090006524E+02 gamma(00000018)=0.133937090006524E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 18 z1= 1 0.621202965803147E-09 0.000000000000000E+00 z1= 2 0.143390404317703E+00 0.000000000000000E+00 z1= 3 -.134259913040901E-06 0.000000000000000E+00 alpha(00000018)=0.000000000000000E+00 beta (00000019)=0.126916716020642E+02 gamma(00000019)=0.126916716020642E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 19 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000019)=0.000000000000000E+00 beta (00000020)=0.133733644050704E+02 gamma(00000020)=0.133733644050704E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 20 z1= 1 -.178271289800504E-07 0.000000000000000E+00 z1= 2 -.131850129935814E+00 0.000000000000000E+00 z1= 3 0.116804156993690E-06 0.000000000000000E+00 alpha(00000020)=0.000000000000000E+00 beta (00000021)=0.127260419543457E+02 gamma(00000021)=0.127260419543457E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 21 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000021)=0.000000000000000E+00 beta (00000022)=0.134820097586215E+02 gamma(00000022)=0.134820097586215E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 22 z1= 1 0.330061950644042E-07 0.000000000000000E+00 z1= 2 0.120961079711797E+00 0.000000000000000E+00 z1= 3 -.999604496218932E-07 0.000000000000000E+00 alpha(00000022)=0.000000000000000E+00 beta (00000023)=0.129128500376165E+02 gamma(00000023)=0.129128500376165E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 23 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000023)=0.000000000000000E+00 beta (00000024)=0.132837300760129E+02 gamma(00000024)=0.132837300760129E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 24 z1= 1 -.471005580163220E-07 0.000000000000000E+00 z1= 2 -.114671638423448E+00 0.000000000000000E+00 z1= 3 0.888081922252506E-07 0.000000000000000E+00 alpha(00000024)=0.000000000000000E+00 beta (00000025)=0.125388178900178E+02 gamma(00000025)=0.125388178900178E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 25 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000025)=0.000000000000000E+00 beta (00000026)=0.135589534448210E+02 gamma(00000026)=0.135589534448210E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 26 z1= 1 0.573124411340845E-07 0.000000000000000E+00 z1= 2 0.103641656520057E+00 0.000000000000000E+00 z1= 3 -.746726549303179E-07 0.000000000000000E+00 alpha(00000026)=0.000000000000000E+00 beta (00000027)=0.129337647282805E+02 gamma(00000027)=0.129337647282805E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 27 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000027)=0.000000000000000E+00 beta (00000028)=0.133335187280650E+02 gamma(00000028)=0.133335187280650E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 28 z1= 1 -.677780337909016E-07 0.000000000000000E+00 z1= 2 -.985033313538826E-01 0.000000000000000E+00 z1= 3 0.678489265578189E-07 0.000000000000000E+00 alpha(00000028)=0.000000000000000E+00 beta (00000029)=0.128951583632955E+02 gamma(00000029)=0.128951583632955E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 29 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000029)=0.000000000000000E+00 beta (00000030)=0.135410738843728E+02 gamma(00000030)=0.135410738843728E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 30 z1= 1 0.773238844060768E-07 0.000000000000000E+00 z1= 2 0.920547035900578E-01 0.000000000000000E+00 z1= 3 -.596426047525661E-07 0.000000000000000E+00 alpha(00000030)=0.000000000000000E+00 beta (00000031)=0.127912912949376E+02 gamma(00000031)=0.127912912949376E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 31 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000031)=0.000000000000000E+00 beta (00000032)=0.133985355860240E+02 gamma(00000032)=0.133985355860240E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 32 z1= 1 -.899845285081899E-07 0.000000000000000E+00 z1= 2 -.864159526934366E-01 0.000000000000000E+00 z1= 3 0.484270568676219E-07 0.000000000000000E+00 alpha(00000032)=0.000000000000000E+00 beta (00000033)=0.127353142688803E+02 gamma(00000033)=0.127353142688803E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 33 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000033)=0.000000000000000E+00 beta (00000034)=0.135903253474315E+02 gamma(00000034)=0.135903253474315E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 34 z1= 1 0.103417130257848E-06 0.000000000000000E+00 z1= 2 0.797402273066882E-01 0.000000000000000E+00 z1= 3 -.348900323948916E-07 0.000000000000000E+00 alpha(00000034)=0.000000000000000E+00 beta (00000035)=0.125676805285675E+02 gamma(00000035)=0.125676805285675E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 35 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000035)=0.000000000000000E+00 beta (00000036)=0.131270524839147E+02 gamma(00000036)=0.131270524839147E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 36 z1= 1 -.123778817273136E-06 0.000000000000000E+00 z1= 2 -.750280346720815E-01 0.000000000000000E+00 z1= 3 0.172481313129649E-07 0.000000000000000E+00 alpha(00000036)=0.000000000000000E+00 beta (00000037)=0.128541686032874E+02 gamma(00000037)=0.128541686032874E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 37 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000037)=0.000000000000000E+00 beta (00000038)=0.133559040618676E+02 gamma(00000038)=0.133559040618676E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 38 z1= 1 0.147331101479388E-06 0.000000000000000E+00 z1= 2 0.711337114429799E-01 0.000000000000000E+00 z1= 3 0.323034069155473E-08 0.000000000000000E+00 alpha(00000038)=0.000000000000000E+00 beta (00000039)=0.128572410748612E+02 gamma(00000039)=0.128572410748612E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 39 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000039)=0.000000000000000E+00 beta (00000040)=0.131516065666338E+02 gamma(00000040)=0.131516065666338E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 40 z1= 1 -.178412042554574E-06 0.000000000000000E+00 z1= 2 -.685793399292193E-01 0.000000000000000E+00 z1= 3 -.288862781906013E-07 0.000000000000000E+00 alpha(00000040)=0.000000000000000E+00 beta (00000041)=0.127262525134203E+02 gamma(00000041)=0.127262525134203E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 41 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000041)=0.000000000000000E+00 beta (00000042)=0.135352414784245E+02 gamma(00000042)=0.135352414784245E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 42 z1= 1 0.202481013560941E-06 0.000000000000000E+00 z1= 2 0.635427464972453E-01 0.000000000000000E+00 z1= 3 0.547308175898042E-07 0.000000000000000E+00 alpha(00000042)=0.000000000000000E+00 beta (00000043)=0.127360207436208E+02 gamma(00000043)=0.127360207436208E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 43 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000043)=0.000000000000000E+00 beta (00000044)=0.133909950739838E+02 gamma(00000044)=0.133909950739838E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 44 z1= 1 -.224931019509808E-06 0.000000000000000E+00 z1= 2 -.595801959435413E-01 0.000000000000000E+00 z1= 3 -.763522110601260E-07 0.000000000000000E+00 alpha(00000044)=0.000000000000000E+00 beta (00000045)=0.124244388144153E+02 gamma(00000045)=0.124244388144153E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 45 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000045)=0.000000000000000E+00 beta (00000046)=0.132663036283290E+02 gamma(00000046)=0.132663036283290E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 46 z1= 1 0.242456739147495E-06 0.000000000000000E+00 z1= 2 0.549390201187777E-01 0.000000000000000E+00 z1= 3 0.946735067485979E-07 0.000000000000000E+00 alpha(00000046)=0.000000000000000E+00 beta (00000047)=0.123512738182746E+02 gamma(00000047)=0.123512738182746E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 47 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000047)=0.000000000000000E+00 beta (00000048)=0.133709997705076E+02 gamma(00000048)=0.133709997705076E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 48 z1= 1 -.257241831190524E-06 0.000000000000000E+00 z1= 2 -.497884302274358E-01 0.000000000000000E+00 z1= 3 -.111304250508589E-06 0.000000000000000E+00 alpha(00000048)=0.000000000000000E+00 beta (00000049)=0.131080324873934E+02 gamma(00000049)=0.131080324873934E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 49 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000049)=0.000000000000000E+00 beta (00000050)=0.136794180886295E+02 gamma(00000050)=0.136794180886295E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 50 z1= 1 0.275788318716830E-06 0.000000000000000E+00 z1= 2 0.469845994308040E-01 0.000000000000000E+00 z1= 3 0.125716013254888E-06 0.000000000000000E+00 alpha(00000050)=0.000000000000000E+00 beta (00000051)=0.126058119421427E+02 gamma(00000051)=0.126058119421427E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 51 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000051)=0.000000000000000E+00 beta (00000052)=0.133780917780969E+02 gamma(00000052)=0.133780917780969E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 52 z1= 1 -.286009836597198E-06 0.000000000000000E+00 z1= 2 -.435537684097727E-01 0.000000000000000E+00 z1= 3 -.134378505693093E-06 0.000000000000000E+00 alpha(00000052)=0.000000000000000E+00 beta (00000053)=0.126303843578749E+02 gamma(00000053)=0.126303843578749E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 53 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000053)=0.000000000000000E+00 beta (00000054)=0.130423032512122E+02 gamma(00000054)=0.130423032512122E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 54 z1= 1 0.299798322629836E-06 0.000000000000000E+00 z1= 2 0.415351825703395E-01 0.000000000000000E+00 z1= 3 0.142070265440886E-06 0.000000000000000E+00 alpha(00000054)=0.000000000000000E+00 beta (00000055)=0.132443016222966E+02 gamma(00000055)=0.132443016222966E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 55 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000055)=0.000000000000000E+00 beta (00000056)=0.133031870882395E+02 gamma(00000056)=0.133031870882395E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 56 z1= 1 -.315884151824534E-06 0.000000000000000E+00 z1= 2 -.408110780834055E-01 0.000000000000000E+00 z1= 3 -.147122317454597E-06 0.000000000000000E+00 alpha(00000056)=0.000000000000000E+00 beta (00000057)=0.130912313788856E+02 gamma(00000057)=0.130912313788856E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 57 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000057)=0.000000000000000E+00 beta (00000058)=0.131870339645786E+02 gamma(00000058)=0.131870339645786E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 58 z1= 1 0.331378402272306E-06 0.000000000000000E+00 z1= 2 0.399651420252595E-01 0.000000000000000E+00 z1= 3 0.152249845015561E-06 0.000000000000000E+00 alpha(00000058)=0.000000000000000E+00 beta (00000059)=0.128670302476193E+02 gamma(00000059)=0.128670302476193E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 59 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000059)=0.000000000000000E+00 beta (00000060)=0.134508624957726E+02 gamma(00000060)=0.134508624957726E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 60 z1= 1 -.334376592360866E-06 0.000000000000000E+00 z1= 2 -.377198319360803E-01 0.000000000000000E+00 z1= 3 -.152238755047208E-06 0.000000000000000E+00 alpha(00000060)=0.000000000000000E+00 beta (00000061)=0.130151314696166E+02 gamma(00000061)=0.130151314696166E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 61 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000061)=0.000000000000000E+00 beta (00000062)=0.137093715080201E+02 gamma(00000062)=0.137093715080201E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 62 z1= 1 0.334631810091496E-06 0.000000000000000E+00 z1= 2 0.352297791339562E-01 0.000000000000000E+00 z1= 3 0.150527862572206E-06 0.000000000000000E+00 alpha(00000062)=0.000000000000000E+00 beta (00000063)=0.129991547682265E+02 gamma(00000063)=0.129991547682265E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 63 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000063)=0.000000000000000E+00 beta (00000064)=0.132904731545009E+02 gamma(00000064)=0.132904731545009E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 64 z1= 1 -.348714925810234E-06 0.000000000000000E+00 z1= 2 -.339057473034383E-01 0.000000000000000E+00 z1= 3 -.156112929459475E-06 0.000000000000000E+00 alpha(00000064)=0.000000000000000E+00 beta (00000065)=0.124219744683805E+02 gamma(00000065)=0.124219744683805E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 65 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000065)=0.000000000000000E+00 beta (00000066)=0.132809546378329E+02 gamma(00000066)=0.132809546378329E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 66 z1= 1 0.351093920652502E-06 0.000000000000000E+00 z1= 2 0.312992509013039E-01 0.000000000000000E+00 z1= 3 0.158527454389296E-06 0.000000000000000E+00 alpha(00000066)=0.000000000000000E+00 beta (00000067)=0.131508957694420E+02 gamma(00000067)=0.131508957694420E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 67 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000067)=0.000000000000000E+00 beta (00000068)=0.137579517895627E+02 gamma(00000068)=0.137579517895627E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 68 z1= 1 -.359216919828577E-06 0.000000000000000E+00 z1= 2 -.296504599881225E-01 0.000000000000000E+00 z1= 3 -.164271893576644E-06 0.000000000000000E+00 alpha(00000068)=0.000000000000000E+00 beta (00000069)=0.129305391299394E+02 gamma(00000069)=0.129305391299394E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 69 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000069)=0.000000000000000E+00 beta (00000070)=0.131645985063918E+02 gamma(00000070)=0.131645985063918E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 70 z1= 1 0.378216947717266E-06 0.000000000000000E+00 z1= 2 0.288885648325210E-01 0.000000000000000E+00 z1= 3 0.174179983700173E-06 0.000000000000000E+00 alpha(00000070)=0.000000000000000E+00 beta (00000071)=0.126044511683209E+02 gamma(00000071)=0.126044511683209E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 71 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000071)=0.000000000000000E+00 beta (00000072)=0.136173433861895E+02 gamma(00000072)=0.136173433861895E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 72 z1= 1 -.378433653011601E-06 0.000000000000000E+00 z1= 2 -.265937042898850E-01 0.000000000000000E+00 z1= 3 -.177803351941036E-06 0.000000000000000E+00 alpha(00000072)=0.000000000000000E+00 beta (00000073)=0.127244328239147E+02 gamma(00000073)=0.127244328239147E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 73 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000073)=0.000000000000000E+00 beta (00000074)=0.131219647250241E+02 gamma(00000074)=0.131219647250241E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 74 z1= 1 0.398289021026274E-06 0.000000000000000E+00 z1= 2 0.255974243748883E-01 0.000000000000000E+00 z1= 3 0.192791168891239E-06 0.000000000000000E+00 alpha(00000074)=0.000000000000000E+00 beta (00000075)=0.124271687865481E+02 gamma(00000075)=0.124271687865481E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 75 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000075)=0.000000000000000E+00 beta (00000076)=0.133410217580479E+02 gamma(00000076)=0.133410217580479E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 76 z1= 1 -.400679682875313E-06 0.000000000000000E+00 z1= 2 -.236182099145837E-01 0.000000000000000E+00 z1= 3 -.197449411367887E-06 0.000000000000000E+00 alpha(00000076)=0.000000000000000E+00 beta (00000077)=0.127582460834768E+02 gamma(00000077)=0.127582460834768E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 77 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000077)=0.000000000000000E+00 beta (00000078)=0.137338064501714E+02 gamma(00000078)=0.137338064501714E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 78 z1= 1 0.403302666370647E-06 0.000000000000000E+00 z1= 2 0.219148751995297E-01 0.000000000000000E+00 z1= 3 0.201847282829855E-06 0.000000000000000E+00 alpha(00000078)=0.000000000000000E+00 beta (00000079)=0.125533710647758E+02 gamma(00000079)=0.125533710647758E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 79 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000079)=0.000000000000000E+00 beta (00000080)=0.132067538587685E+02 gamma(00000080)=0.132067538587685E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 80 z1= 1 -.415848616564310E-06 0.000000000000000E+00 z1= 2 -.209236236614102E-01 0.000000000000000E+00 z1= 3 -.210009486896132E-06 0.000000000000000E+00 alpha(00000080)=0.000000000000000E+00 beta (00000081)=0.127296769759626E+02 gamma(00000081)=0.127296769759626E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 81 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000081)=0.000000000000000E+00 beta (00000082)=0.138731635759974E+02 gamma(00000082)=0.138731635759974E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 82 z1= 1 0.410807510311390E-06 0.000000000000000E+00 z1= 2 0.193308037202156E-01 0.000000000000000E+00 z1= 3 0.208111471311154E-06 0.000000000000000E+00 alpha(00000082)=0.000000000000000E+00 beta (00000083)=0.126812279124141E+02 gamma(00000083)=0.126812279124141E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 83 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000083)=0.000000000000000E+00 beta (00000084)=0.130964116226479E+02 gamma(00000084)=0.130964116226479E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 84 z1= 1 -.429928368001972E-06 0.000000000000000E+00 z1= 2 -.188109176613343E-01 0.000000000000000E+00 z1= 3 -.219704274522468E-06 0.000000000000000E+00 alpha(00000084)=0.000000000000000E+00 beta (00000085)=0.126005772285617E+02 gamma(00000085)=0.126005772285617E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 85 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000085)=0.000000000000000E+00 beta (00000086)=0.139568604702364E+02 gamma(00000086)=0.139568604702364E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 86 z1= 1 0.417939002969950E-06 0.000000000000000E+00 z1= 2 0.169458161976587E-01 0.000000000000000E+00 z1= 3 0.215439303246148E-06 0.000000000000000E+00 alpha(00000086)=0.000000000000000E+00 beta (00000087)=0.125283230139314E+02 gamma(00000087)=0.125283230139314E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 87 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000087)=0.000000000000000E+00 beta (00000088)=0.130426656425640E+02 gamma(00000088)=0.130426656425640E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 88 z1= 1 -.430379170950762E-06 0.000000000000000E+00 z1= 2 -.160286484886605E-01 0.000000000000000E+00 z1= 3 -.220430348872418E-06 0.000000000000000E+00 alpha(00000088)=0.000000000000000E+00 beta (00000089)=0.129410179884290E+02 gamma(00000089)=0.129410179884290E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 89 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000089)=0.000000000000000E+00 beta (00000090)=0.135148924616972E+02 gamma(00000090)=0.135148924616972E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 90 z1= 1 0.434645514997903E-06 0.000000000000000E+00 z1= 2 0.149679632358105E-01 0.000000000000000E+00 z1= 3 0.218419816595296E-06 0.000000000000000E+00 alpha(00000090)=0.000000000000000E+00 beta (00000091)=0.124482048516116E+02 gamma(00000091)=0.124482048516116E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 91 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000091)=0.000000000000000E+00 beta (00000092)=0.130591012757420E+02 gamma(00000092)=0.130591012757420E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 92 z1= 1 -.439902426253164E-06 0.000000000000000E+00 z1= 2 -.138409108479858E-01 0.000000000000000E+00 z1= 3 -.217292612541241E-06 0.000000000000000E+00 alpha(00000092)=0.000000000000000E+00 beta (00000093)=0.130360451394932E+02 gamma(00000093)=0.130360451394932E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 93 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000093)=0.000000000000000E+00 beta (00000094)=0.129280178986900E+02 gamma(00000094)=0.129280178986900E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 94 z1= 1 0.465239161502942E-06 0.000000000000000E+00 z1= 2 0.135223209092418E-01 0.000000000000000E+00 z1= 3 0.224305421514526E-06 0.000000000000000E+00 alpha(00000094)=0.000000000000000E+00 beta (00000095)=0.122336917090806E+02 gamma(00000095)=0.122336917090806E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 95 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000095)=0.000000000000000E+00 beta (00000096)=0.128080685305546E+02 gamma(00000096)=0.128080685305546E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 96 z1= 1 -.465082740324849E-06 0.000000000000000E+00 z1= 2 -.125726889336509E-01 0.000000000000000E+00 z1= 3 -.217580860330593E-06 0.000000000000000E+00 alpha(00000096)=0.000000000000000E+00 beta (00000097)=0.127706175831866E+02 gamma(00000097)=0.127706175831866E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 97 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000097)=0.000000000000000E+00 beta (00000098)=0.126718472185710E+02 gamma(00000098)=0.126718472185710E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 98 z1= 1 0.490878823238700E-06 0.000000000000000E+00 z1= 2 0.122625694983793E-01 0.000000000000000E+00 z1= 3 0.224812752044543E-06 0.000000000000000E+00 alpha(00000098)=0.000000000000000E+00 beta (00000099)=0.122002914994445E+02 gamma(00000099)=0.122002914994445E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 99 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000099)=0.000000000000000E+00 beta (00000100)=0.134328826283367E+02 gamma(00000100)=0.134328826283367E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 100 z1= 1 -.460957997055686E-06 0.000000000000000E+00 z1= 2 -.107982450173891E-01 0.000000000000000E+00 z1= 3 -.203849584307254E-06 0.000000000000000E+00 alpha(00000100)=0.000000000000000E+00 beta (00000101)=0.129919945193883E+02 gamma(00000101)=0.129919945193883E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 101 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000101)=0.000000000000000E+00 beta (00000102)=0.132098935475480E+02 gamma(00000102)=0.132098935475480E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 102 z1= 1 0.463199570456541E-06 0.000000000000000E+00 z1= 2 0.104500313251434E-01 0.000000000000000E+00 z1= 3 0.197040854685478E-06 0.000000000000000E+00 alpha(00000102)=0.000000000000000E+00 beta (00000103)=0.133614114476082E+02 gamma(00000103)=0.133614114476082E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 103 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000103)=0.000000000000000E+00 beta (00000104)=0.128938384599491E+02 gamma(00000104)=0.128938384599491E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 104 z1= 1 -.492511658517145E-06 0.000000000000000E+00 z1= 2 -.110563589113243E-01 0.000000000000000E+00 z1= 3 -.205620603790230E-06 0.000000000000000E+00 alpha(00000104)=0.000000000000000E+00 beta (00000105)=0.132018188526767E+02 gamma(00000105)=0.132018188526767E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 105 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000105)=0.000000000000000E+00 beta (00000106)=0.137901553982909E+02 gamma(00000106)=0.137901553982909E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 106 z1= 1 0.483935805135546E-06 0.000000000000000E+00 z1= 2 0.109268986593908E-01 0.000000000000000E+00 z1= 3 0.199162916768823E-06 0.000000000000000E+00 alpha(00000106)=0.000000000000000E+00 beta (00000107)=0.131785121404493E+02 gamma(00000107)=0.131785121404493E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 107 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000107)=0.000000000000000E+00 beta (00000108)=0.132913084647279E+02 gamma(00000108)=0.132913084647279E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 108 z1= 1 -.492775340671381E-06 0.000000000000000E+00 z1= 2 -.111477901693258E-01 0.000000000000000E+00 z1= 3 -.200602888847899E-06 0.000000000000000E+00 alpha(00000108)=0.000000000000000E+00 beta (00000109)=0.131813986385829E+02 gamma(00000109)=0.131813986385829E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 109 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000109)=0.000000000000000E+00 beta (00000110)=0.128018457407935E+02 gamma(00000110)=0.128018457407935E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 110 z1= 1 0.518843024965507E-06 0.000000000000000E+00 z1= 2 0.117677412223636E-01 0.000000000000000E+00 z1= 3 0.207357869962295E-06 0.000000000000000E+00 alpha(00000110)=0.000000000000000E+00 beta (00000111)=0.130264161745466E+02 gamma(00000111)=0.130264161745466E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 111 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000111)=0.000000000000000E+00 beta (00000112)=0.134223597206583E+02 gamma(00000112)=0.134223597206583E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 112 z1= 1 -.506980887788472E-06 0.000000000000000E+00 z1= 2 -.115151800204135E-01 0.000000000000000E+00 z1= 3 -.193819874383556E-06 0.000000000000000E+00 alpha(00000112)=0.000000000000000E+00 beta (00000113)=0.126782697935820E+02 gamma(00000113)=0.126782697935820E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 113 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000113)=0.000000000000000E+00 beta (00000114)=0.131589961067845E+02 gamma(00000114)=0.131589961067845E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 114 z1= 1 0.491643496461011E-06 0.000000000000000E+00 z1= 2 0.111951190509958E-01 0.000000000000000E+00 z1= 3 0.179497070819726E-06 0.000000000000000E+00 alpha(00000114)=0.000000000000000E+00 beta (00000115)=0.124669199489929E+02 gamma(00000115)=0.124669199489929E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 115 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000115)=0.000000000000000E+00 beta (00000116)=0.134367293202692E+02 gamma(00000116)=0.134367293202692E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 116 z1= 1 -.465275462779163E-06 0.000000000000000E+00 z1= 2 -.107811443461387E-01 0.000000000000000E+00 z1= 3 -.165330560117360E-06 0.000000000000000E+00 alpha(00000116)=0.000000000000000E+00 beta (00000117)=0.123608419890268E+02 gamma(00000117)=0.123608419890268E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 117 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000117)=0.000000000000000E+00 beta (00000118)=0.132506551835363E+02 gamma(00000118)=0.132506551835363E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 118 z1= 1 0.445964405510271E-06 0.000000000000000E+00 z1= 2 0.103649670340192E-01 0.000000000000000E+00 z1= 3 0.154241880619306E-06 0.000000000000000E+00 alpha(00000118)=0.000000000000000E+00 beta (00000119)=0.127796538992022E+02 gamma(00000119)=0.127796538992022E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 119 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000119)=0.000000000000000E+00 beta (00000120)=0.132042560875283E+02 gamma(00000120)=0.132042560875283E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 120 z1= 1 -.437360361246752E-06 0.000000000000000E+00 z1= 2 -.100927388095965E-01 0.000000000000000E+00 z1= 3 -.143265947028480E-06 0.000000000000000E+00 alpha(00000120)=0.000000000000000E+00 beta (00000121)=0.123933041529620E+02 gamma(00000121)=0.123933041529620E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 121 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000121)=0.000000000000000E+00 beta (00000122)=0.129982080183232E+02 gamma(00000122)=0.129982080183232E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 122 z1= 1 0.422057364200118E-06 0.000000000000000E+00 z1= 2 0.968946852218919E-02 0.000000000000000E+00 z1= 3 0.130080351526743E-06 0.000000000000000E+00 alpha(00000122)=0.000000000000000E+00 beta (00000123)=0.128338261620185E+02 gamma(00000123)=0.128338261620185E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 123 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000123)=0.000000000000000E+00 beta (00000124)=0.135790422894999E+02 gamma(00000124)=0.135790422894999E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 124 z1= 1 -.400765948305876E-06 0.000000000000000E+00 z1= 2 -.907007768718743E-02 0.000000000000000E+00 z1= 3 -.114371159366106E-06 0.000000000000000E+00 alpha(00000124)=0.000000000000000E+00 beta (00000125)=0.128904241436747E+02 gamma(00000125)=0.128904241436747E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 125 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000125)=0.000000000000000E+00 beta (00000126)=0.135564019757678E+02 gamma(00000126)=0.135564019757678E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 126 z1= 1 0.388426343849585E-06 0.000000000000000E+00 z1= 2 0.862234991069192E-02 0.000000000000000E+00 z1= 3 0.107495426700591E-06 0.000000000000000E+00 alpha(00000126)=0.000000000000000E+00 beta (00000127)=0.127971584807956E+02 gamma(00000127)=0.127971584807956E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 127 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000127)=0.000000000000000E+00 beta (00000128)=0.136536951246367E+02 gamma(00000128)=0.136536951246367E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 128 z1= 1 -.377276303288598E-06 0.000000000000000E+00 z1= 2 -.825989860210402E-02 0.000000000000000E+00 z1= 3 -.107255478599272E-06 0.000000000000000E+00 alpha(00000128)=0.000000000000000E+00 beta (00000129)=0.127278126560774E+02 gamma(00000129)=0.127278126560774E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 129 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000129)=0.000000000000000E+00 beta (00000130)=0.130491566390538E+02 gamma(00000130)=0.130491566390538E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 130 z1= 1 0.376109906928893E-06 0.000000000000000E+00 z1= 2 0.813357789437293E-02 0.000000000000000E+00 z1= 3 0.106056685400882E-06 0.000000000000000E+00 alpha(00000130)=0.000000000000000E+00 beta (00000131)=0.130564092286688E+02 gamma(00000131)=0.130564092286688E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 131 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000131)=0.000000000000000E+00 beta (00000132)=0.136082468636313E+02 gamma(00000132)=0.136082468636313E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 132 z1= 1 -.368322357587395E-06 0.000000000000000E+00 z1= 2 -.780708183190003E-02 0.000000000000000E+00 z1= 3 -.102060284986293E-06 0.000000000000000E+00 alpha(00000132)=0.000000000000000E+00 beta (00000133)=0.122641342433163E+02 gamma(00000133)=0.122641342433163E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 133 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000133)=0.000000000000000E+00 beta (00000134)=0.133450912998000E+02 gamma(00000134)=0.133450912998000E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 134 z1= 1 0.351269727156406E-06 0.000000000000000E+00 z1= 2 0.713741752605340E-02 0.000000000000000E+00 z1= 3 0.990300580263129E-07 0.000000000000000E+00 alpha(00000134)=0.000000000000000E+00 beta (00000135)=0.129189967044432E+02 gamma(00000135)=0.129189967044432E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 135 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000135)=0.000000000000000E+00 beta (00000136)=0.133088303806199E+02 gamma(00000136)=0.133088303806199E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 136 z1= 1 -.356053897872244E-06 0.000000000000000E+00 z1= 2 -.681475179803778E-02 0.000000000000000E+00 z1= 3 -.105568997733722E-06 0.000000000000000E+00 alpha(00000136)=0.000000000000000E+00 beta (00000137)=0.119893051855611E+02 gamma(00000137)=0.119893051855611E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 137 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000137)=0.000000000000000E+00 beta (00000138)=0.134043263635298E+02 gamma(00000138)=0.134043263635298E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 138 z1= 1 0.330791201808706E-06 0.000000000000000E+00 z1= 2 0.596163045351244E-02 0.000000000000000E+00 z1= 3 0.100438820432522E-06 0.000000000000000E+00 alpha(00000138)=0.000000000000000E+00 beta (00000139)=0.129875621868833E+02 gamma(00000139)=0.129875621868833E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 139 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000139)=0.000000000000000E+00 beta (00000140)=0.133426465293042E+02 gamma(00000140)=0.133426465293042E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 140 z1= 1 -.334767854579671E-06 0.000000000000000E+00 z1= 2 -.573466655766134E-02 0.000000000000000E+00 z1= 3 -.103415869274343E-06 0.000000000000000E+00 alpha(00000140)=0.000000000000000E+00 beta (00000141)=0.130003730675638E+02 gamma(00000141)=0.130003730675638E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 141 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000141)=0.000000000000000E+00 beta (00000142)=0.134435857196604E+02 gamma(00000142)=0.134435857196604E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 142 z1= 1 0.338825658689756E-06 0.000000000000000E+00 z1= 2 0.582661102580883E-02 0.000000000000000E+00 z1= 3 0.107798271435124E-06 0.000000000000000E+00 alpha(00000142)=0.000000000000000E+00 beta (00000143)=0.125646166419607E+02 gamma(00000143)=0.125646166419607E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 143 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000143)=0.000000000000000E+00 beta (00000144)=0.137008220176051E+02 gamma(00000144)=0.137008220176051E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 144 z1= 1 -.321014373501696E-06 0.000000000000000E+00 z1= 2 -.579860518077313E-02 0.000000000000000E+00 z1= 3 -.102455835564695E-06 0.000000000000000E+00 alpha(00000144)=0.000000000000000E+00 beta (00000145)=0.132286715922185E+02 gamma(00000145)=0.132286715922185E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 145 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000145)=0.000000000000000E+00 beta (00000146)=0.139206126789340E+02 gamma(00000146)=0.139206126789340E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 146 z1= 1 0.313511359026353E-06 0.000000000000000E+00 z1= 2 0.599593537720854E-02 0.000000000000000E+00 z1= 3 0.100135565363896E-06 0.000000000000000E+00 alpha(00000146)=0.000000000000000E+00 beta (00000147)=0.127797039994262E+02 gamma(00000147)=0.127797039994262E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 147 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000147)=0.000000000000000E+00 beta (00000148)=0.129455483208856E+02 gamma(00000148)=0.129455483208856E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 148 z1= 1 -.323265649190135E-06 0.000000000000000E+00 z1= 2 -.646283835347045E-02 0.000000000000000E+00 z1= 3 -.105922945438201E-06 0.000000000000000E+00 alpha(00000148)=0.000000000000000E+00 beta (00000149)=0.129403304379363E+02 gamma(00000149)=0.129403304379363E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 149 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000149)=0.000000000000000E+00 beta (00000150)=0.130980292369528E+02 gamma(00000150)=0.130980292369528E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 150 z1= 1 0.329390766159315E-06 0.000000000000000E+00 z1= 2 0.673195654222924E-02 0.000000000000000E+00 z1= 3 0.108447194109400E-06 0.000000000000000E+00 alpha(00000150)=0.000000000000000E+00 beta (00000151)=0.128424240375113E+02 gamma(00000151)=0.128424240375113E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 151 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000151)=0.000000000000000E+00 beta (00000152)=0.139447991413520E+02 gamma(00000152)=0.139447991413520E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 152 z1= 1 -.304884374044065E-06 0.000000000000000E+00 z1= 2 -.644031117156374E-02 0.000000000000000E+00 z1= 3 -.945660305522525E-07 0.000000000000000E+00 alpha(00000152)=0.000000000000000E+00 beta (00000153)=0.124657938195600E+02 gamma(00000153)=0.124657938195600E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 153 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000153)=0.000000000000000E+00 beta (00000154)=0.135700263661468E+02 gamma(00000154)=0.135700263661468E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 154 z1= 1 0.278433590430310E-06 0.000000000000000E+00 z1= 2 0.616272370748323E-02 0.000000000000000E+00 z1= 3 0.774906490285873E-07 0.000000000000000E+00 alpha(00000154)=0.000000000000000E+00 beta (00000155)=0.124067859969240E+02 gamma(00000155)=0.124067859969240E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 155 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000155)=0.000000000000000E+00 beta (00000156)=0.132267177864186E+02 gamma(00000156)=0.132267177864186E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 156 z1= 1 -.257520532015096E-06 0.000000000000000E+00 z1= 2 -.595885009723552E-02 0.000000000000000E+00 z1= 3 -.614742649753669E-07 0.000000000000000E+00 alpha(00000156)=0.000000000000000E+00 beta (00000157)=0.125236520219701E+02 gamma(00000157)=0.125236520219701E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 157 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000157)=0.000000000000000E+00 beta (00000158)=0.135215449728430E+02 gamma(00000158)=0.135215449728430E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 158 z1= 1 0.237547889201176E-06 0.000000000000000E+00 z1= 2 0.552074926001534E-02 0.000000000000000E+00 z1= 3 0.482435303962581E-07 0.000000000000000E+00 alpha(00000158)=0.000000000000000E+00 beta (00000159)=0.127881281881146E+02 gamma(00000159)=0.127881281881146E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 159 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000159)=0.000000000000000E+00 beta (00000160)=0.139485765952595E+02 gamma(00000160)=0.139485765952595E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 160 z1= 1 -.220875164392773E-06 0.000000000000000E+00 z1= 2 -.498079962703348E-02 0.000000000000000E+00 z1= 3 -.404491966492573E-07 0.000000000000000E+00 alpha(00000160)=0.000000000000000E+00 beta (00000161)=0.127763307090103E+02 gamma(00000161)=0.127763307090103E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 161 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000161)=0.000000000000000E+00 beta (00000162)=0.130878495523595E+02 gamma(00000162)=0.130878495523595E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 162 z1= 1 0.222290280200294E-06 0.000000000000000E+00 z1= 2 0.478114205647718E-02 0.000000000000000E+00 z1= 3 0.381507548798815E-07 0.000000000000000E+00 alpha(00000162)=0.000000000000000E+00 beta (00000163)=0.131378766999207E+02 gamma(00000163)=0.131378766999207E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 163 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000163)=0.000000000000000E+00 beta (00000164)=0.129852890142801E+02 gamma(00000164)=0.129852890142801E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 164 z1= 1 -.233445457055448E-06 0.000000000000000E+00 z1= 2 -.443841203714568E-02 0.000000000000000E+00 z1= 3 -.391495154645344E-07 0.000000000000000E+00 alpha(00000164)=0.000000000000000E+00 beta (00000165)=0.126250386744206E+02 gamma(00000165)=0.126250386744206E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 165 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000165)=0.000000000000000E+00 beta (00000166)=0.133717530264464E+02 gamma(00000166)=0.133717530264464E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 166 z1= 1 0.225950343222051E-06 0.000000000000000E+00 z1= 2 0.346204049727576E-02 0.000000000000000E+00 z1= 3 0.348274457762782E-07 0.000000000000000E+00 alpha(00000166)=0.000000000000000E+00 beta (00000167)=0.127608890774474E+02 gamma(00000167)=0.127608890774474E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 167 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000167)=0.000000000000000E+00 beta (00000168)=0.141892526045452E+02 gamma(00000168)=0.141892526045452E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 168 z1= 1 -.206031165199752E-06 0.000000000000000E+00 z1= 2 -.250642150292881E-02 0.000000000000000E+00 z1= 3 -.265728469185308E-07 0.000000000000000E+00 alpha(00000168)=0.000000000000000E+00 beta (00000169)=0.122983040643063E+02 gamma(00000169)=0.122983040643063E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 169 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000169)=0.000000000000000E+00 beta (00000170)=0.136209311692077E+02 gamma(00000170)=0.136209311692077E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 170 z1= 1 0.190556959222404E-06 0.000000000000000E+00 z1= 2 0.191505538933750E-02 0.000000000000000E+00 z1= 3 0.214953675336735E-07 0.000000000000000E+00 alpha(00000170)=0.000000000000000E+00 beta (00000171)=0.122697386929037E+02 gamma(00000171)=0.122697386929037E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 171 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000171)=0.000000000000000E+00 beta (00000172)=0.129523593450072E+02 gamma(00000172)=0.129523593450072E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 172 z1= 1 -.186578057078009E-06 0.000000000000000E+00 z1= 2 -.169676246489085E-02 0.000000000000000E+00 z1= 3 -.201721284021246E-07 0.000000000000000E+00 alpha(00000172)=0.000000000000000E+00 beta (00000173)=0.122351732699768E+02 gamma(00000173)=0.122351732699768E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 173 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000173)=0.000000000000000E+00 beta (00000174)=0.139756755682418E+02 gamma(00000174)=0.139756755682418E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 174 z1= 1 0.167443171963239E-06 0.000000000000000E+00 z1= 2 0.133511903153002E-02 0.000000000000000E+00 z1= 3 0.163623004919428E-07 0.000000000000000E+00 alpha(00000174)=0.000000000000000E+00 beta (00000175)=0.129307164987354E+02 gamma(00000175)=0.129307164987354E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 175 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000175)=0.000000000000000E+00 beta (00000176)=0.132725170659143E+02 gamma(00000176)=0.132725170659143E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 176 z1= 1 -.173183208625367E-06 0.000000000000000E+00 z1= 2 -.112920482635042E-02 0.000000000000000E+00 z1= 3 -.209449719360856E-07 0.000000000000000E+00 alpha(00000176)=0.000000000000000E+00 beta (00000177)=0.125054744816498E+02 gamma(00000177)=0.125054744816498E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 177 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000177)=0.000000000000000E+00 beta (00000178)=0.133813260301372E+02 gamma(00000178)=0.133813260301372E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 178 z1= 1 0.175023200444865E-06 0.000000000000000E+00 z1= 2 0.826277745743118E-03 0.000000000000000E+00 z1= 3 0.276019707975278E-07 0.000000000000000E+00 alpha(00000178)=0.000000000000000E+00 beta (00000179)=0.126357143937911E+02 gamma(00000179)=0.126357143937911E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 179 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000179)=0.000000000000000E+00 beta (00000180)=0.131777768371374E+02 gamma(00000180)=0.131777768371374E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 180 z1= 1 -.178075768862522E-06 0.000000000000000E+00 z1= 2 -.421350928333223E-03 0.000000000000000E+00 z1= 3 -.306002237880285E-07 0.000000000000000E+00 alpha(00000180)=0.000000000000000E+00 beta (00000181)=0.126295216086236E+02 gamma(00000181)=0.126295216086236E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 181 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000181)=0.000000000000000E+00 beta (00000182)=0.132336337353738E+02 gamma(00000182)=0.132336337353738E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 182 z1= 1 0.179443608095027E-06 0.000000000000000E+00 z1= 2 -.141110606694871E-03 0.000000000000000E+00 z1= 3 0.325464606242172E-07 0.000000000000000E+00 alpha(00000182)=0.000000000000000E+00 beta (00000183)=0.129114599392899E+02 gamma(00000183)=0.129114599392899E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 183 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000183)=0.000000000000000E+00 beta (00000184)=0.135800892594477E+02 gamma(00000184)=0.135800892594477E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 184 z1= 1 -.172712529533312E-06 0.000000000000000E+00 z1= 2 0.756159688295862E-03 0.000000000000000E+00 z1= 3 -.273338870895173E-07 0.000000000000000E+00 alpha(00000184)=0.000000000000000E+00 beta (00000185)=0.129480125086411E+02 gamma(00000185)=0.129480125086411E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 185 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000185)=0.000000000000000E+00 beta (00000186)=0.136308601111739E+02 gamma(00000186)=0.136308601111739E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 186 z1= 1 0.166738759665649E-06 0.000000000000000E+00 z1= 2 -.114707523261889E-02 0.000000000000000E+00 z1= 3 0.224030328871416E-07 0.000000000000000E+00 alpha(00000186)=0.000000000000000E+00 beta (00000187)=0.125086699772019E+02 gamma(00000187)=0.125086699772019E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 187 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000187)=0.000000000000000E+00 beta (00000188)=0.136340957832800E+02 gamma(00000188)=0.136340957832800E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 188 z1= 1 -.162252977740050E-06 0.000000000000000E+00 z1= 2 0.136069572529121E-02 0.000000000000000E+00 z1= 3 -.253520480268665E-07 0.000000000000000E+00 alpha(00000188)=0.000000000000000E+00 beta (00000189)=0.126286711973461E+02 gamma(00000189)=0.126286711973461E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 189 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000189)=0.000000000000000E+00 beta (00000190)=0.134171158744476E+02 gamma(00000190)=0.134171158744476E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 190 z1= 1 0.163567446699077E-06 0.000000000000000E+00 z1= 2 -.161830308246028E-02 0.000000000000000E+00 z1= 3 0.299764360725367E-07 0.000000000000000E+00 alpha(00000190)=0.000000000000000E+00 beta (00000191)=0.124710809272389E+02 gamma(00000191)=0.124710809272389E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 191 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000191)=0.000000000000000E+00 beta (00000192)=0.136215036765203E+02 gamma(00000192)=0.136215036765203E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 192 z1= 1 -.156815179275932E-06 0.000000000000000E+00 z1= 2 0.180517310888194E-02 0.000000000000000E+00 z1= 3 -.299913308038184E-07 0.000000000000000E+00 alpha(00000192)=0.000000000000000E+00 beta (00000193)=0.130478558710687E+02 gamma(00000193)=0.130478558710687E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 193 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000193)=0.000000000000000E+00 beta (00000194)=0.130881996793909E+02 gamma(00000194)=0.130881996793909E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 194 z1= 1 0.158952829019780E-06 0.000000000000000E+00 z1= 2 -.218370105332057E-02 0.000000000000000E+00 z1= 3 0.287331955502873E-07 0.000000000000000E+00 alpha(00000194)=0.000000000000000E+00 beta (00000195)=0.133222086044990E+02 gamma(00000195)=0.133222086044990E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 195 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000195)=0.000000000000000E+00 beta (00000196)=0.134810902780126E+02 gamma(00000196)=0.134810902780126E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 196 z1= 1 -.160225731474228E-06 0.000000000000000E+00 z1= 2 0.212244695330807E-02 0.000000000000000E+00 z1= 3 -.293163049227066E-07 0.000000000000000E+00 alpha(00000196)=0.000000000000000E+00 beta (00000197)=0.132472197877677E+02 gamma(00000197)=0.132472197877677E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 197 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000197)=0.000000000000000E+00 beta (00000198)=0.130644084952357E+02 gamma(00000198)=0.130644084952357E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 198 z1= 1 0.170398039466696E-06 0.000000000000000E+00 z1= 2 -.184138941066277E-02 0.000000000000000E+00 z1= 3 0.362553058785679E-07 0.000000000000000E+00 alpha(00000198)=0.000000000000000E+00 beta (00000199)=0.119855526946482E+02 gamma(00000199)=0.119855526946482E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 199 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000199)=0.000000000000000E+00 beta (00000200)=0.135632944926267E+02 gamma(00000200)=0.135632944926267E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 200 z1= 1 -.163540088147021E-06 0.000000000000000E+00 z1= 2 0.105281710749729E-02 0.000000000000000E+00 z1= 3 -.442519625643532E-07 0.000000000000000E+00 alpha(00000200)=0.000000000000000E+00 beta (00000201)=0.127088702505503E+02 gamma(00000201)=0.127088702505503E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 201 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000201)=0.000000000000000E+00 beta (00000202)=0.138555332320106E+02 gamma(00000202)=0.138555332320106E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 202 z1= 1 0.161290641531066E-06 0.000000000000000E+00 z1= 2 -.269594103133490E-03 0.000000000000000E+00 z1= 3 0.508796850662470E-07 0.000000000000000E+00 alpha(00000202)=0.000000000000000E+00 beta (00000203)=0.126095872481826E+02 gamma(00000203)=0.126095872481826E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 203 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000203)=0.000000000000000E+00 beta (00000204)=0.134126309388535E+02 gamma(00000204)=0.134126309388535E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 204 z1= 1 -.160595689416114E-06 0.000000000000000E+00 z1= 2 -.321683548197679E-03 0.000000000000000E+00 z1= 3 -.573579844532005E-07 0.000000000000000E+00 alpha(00000204)=0.000000000000000E+00 beta (00000205)=0.123936102718670E+02 gamma(00000205)=0.123936102718670E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 205 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000205)=0.000000000000000E+00 beta (00000206)=0.129976854515399E+02 gamma(00000206)=0.129976854515399E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 206 z1= 1 0.159953866030009E-06 0.000000000000000E+00 z1= 2 0.974403453916745E-03 0.000000000000000E+00 z1= 3 0.634032844911044E-07 0.000000000000000E+00 alpha(00000206)=0.000000000000000E+00 beta (00000207)=0.122480880929139E+02 gamma(00000207)=0.122480880929139E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 207 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000207)=0.000000000000000E+00 beta (00000208)=0.134240957724724E+02 gamma(00000208)=0.134240957724724E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 208 z1= 1 -.151655070852914E-06 0.000000000000000E+00 z1= 2 -.164571293161370E-02 0.000000000000000E+00 z1= 3 -.649231754255679E-07 0.000000000000000E+00 alpha(00000208)=0.000000000000000E+00 beta (00000209)=0.126747677082364E+02 gamma(00000209)=0.126747677082364E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 209 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000209)=0.000000000000000E+00 beta (00000210)=0.134540275089477E+02 gamma(00000210)=0.134540275089477E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 210 z1= 1 0.159374255978215E-06 0.000000000000000E+00 z1= 2 0.281909213197201E-02 0.000000000000000E+00 z1= 3 0.786053231428829E-07 0.000000000000000E+00 alpha(00000210)=0.000000000000000E+00 beta (00000211)=0.123271001858431E+02 gamma(00000211)=0.123271001858431E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 211 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000211)=0.000000000000000E+00 beta (00000212)=0.129888493290614E+02 gamma(00000212)=0.129888493290614E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 212 z1= 1 -.174902376222710E-06 0.000000000000000E+00 z1= 2 -.388858382738864E-02 0.000000000000000E+00 z1= 3 -.989936180715266E-07 0.000000000000000E+00 alpha(00000212)=0.000000000000000E+00 beta (00000213)=0.130784540983391E+02 gamma(00000213)=0.130784540983391E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 213 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000213)=0.000000000000000E+00 beta (00000214)=0.133370725795302E+02 gamma(00000214)=0.133370725795302E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 214 z1= 1 0.194994437307909E-06 0.000000000000000E+00 z1= 2 0.442280088036501E-02 0.000000000000000E+00 z1= 3 0.119933524160998E-06 0.000000000000000E+00 alpha(00000214)=0.000000000000000E+00 beta (00000215)=0.122604410264028E+02 gamma(00000215)=0.122604410264028E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 215 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000215)=0.000000000000000E+00 beta (00000216)=0.135149441652623E+02 gamma(00000216)=0.135149441652623E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 216 z1= 1 -.190265891392843E-06 0.000000000000000E+00 z1= 2 -.413644293537126E-02 0.000000000000000E+00 z1= 3 -.118642749467272E-06 0.000000000000000E+00 alpha(00000216)=0.000000000000000E+00 beta (00000217)=0.130597397483049E+02 gamma(00000217)=0.130597397483049E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 217 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000217)=0.000000000000000E+00 beta (00000218)=0.134738738934126E+02 gamma(00000218)=0.134738738934126E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 218 z1= 1 0.189142765603424E-06 0.000000000000000E+00 z1= 2 0.364134735942736E-02 0.000000000000000E+00 z1= 3 0.114688184235136E-06 0.000000000000000E+00 alpha(00000218)=0.000000000000000E+00 beta (00000219)=0.123569729711499E+02 gamma(00000219)=0.123569729711499E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 219 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000219)=0.000000000000000E+00 beta (00000220)=0.139261581204919E+02 gamma(00000220)=0.139261581204919E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 220 z1= 1 -.173545317996935E-06 0.000000000000000E+00 z1= 2 -.264218174163106E-02 0.000000000000000E+00 z1= 3 -.101376466983636E-06 0.000000000000000E+00 alpha(00000220)=0.000000000000000E+00 beta (00000221)=0.127827356944414E+02 gamma(00000221)=0.127827356944414E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 221 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000221)=0.000000000000000E+00 beta (00000222)=0.132363286362439E+02 gamma(00000222)=0.132363286362439E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 222 z1= 1 0.166481863162881E-06 0.000000000000000E+00 z1= 2 0.182436249836930E-02 0.000000000000000E+00 z1= 3 0.879022118743973E-07 0.000000000000000E+00 alpha(00000222)=0.000000000000000E+00 beta (00000223)=0.126638490519620E+02 gamma(00000223)=0.126638490519620E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 223 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000223)=0.000000000000000E+00 beta (00000224)=0.133440128714127E+02 gamma(00000224)=0.133440128714127E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 224 z1= 1 -.153283663821297E-06 0.000000000000000E+00 z1= 2 -.101408929709589E-02 0.000000000000000E+00 z1= 3 -.689440327310969E-07 0.000000000000000E+00 alpha(00000224)=0.000000000000000E+00 beta (00000225)=0.129139441816643E+02 gamma(00000225)=0.129139441816643E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 225 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000225)=0.000000000000000E+00 beta (00000226)=0.135823736580797E+02 gamma(00000226)=0.135823736580797E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 226 z1= 1 0.144597257890813E-06 0.000000000000000E+00 z1= 2 0.366234125595253E-03 0.000000000000000E+00 z1= 3 0.555769691544181E-07 0.000000000000000E+00 alpha(00000226)=0.000000000000000E+00 beta (00000227)=0.126079353613056E+02 gamma(00000227)=0.126079353613056E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 227 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000227)=0.000000000000000E+00 beta (00000228)=0.134590208185955E+02 gamma(00000228)=0.134590208185955E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 228 z1= 1 -.133952957804065E-06 0.000000000000000E+00 z1= 2 0.425712278143759E-03 0.000000000000000E+00 z1= 3 -.410556131101407E-07 0.000000000000000E+00 alpha(00000228)=0.000000000000000E+00 beta (00000229)=0.126354587170182E+02 gamma(00000229)=0.126354587170182E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 229 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000229)=0.000000000000000E+00 beta (00000230)=0.132693327884449E+02 gamma(00000230)=0.132693327884449E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 230 z1= 1 0.129921939903948E-06 0.000000000000000E+00 z1= 2 -.127850407646141E-02 0.000000000000000E+00 z1= 3 0.347784694584852E-07 0.000000000000000E+00 alpha(00000230)=0.000000000000000E+00 beta (00000231)=0.128192366956823E+02 gamma(00000231)=0.128192366956823E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 231 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000231)=0.000000000000000E+00 beta (00000232)=0.131443060891778E+02 gamma(00000232)=0.131443060891778E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 232 z1= 1 -.133261230322781E-06 0.000000000000000E+00 z1= 2 0.213925570471934E-02 0.000000000000000E+00 z1= 3 -.352897479819099E-07 0.000000000000000E+00 alpha(00000232)=0.000000000000000E+00 beta (00000233)=0.117135007449212E+02 gamma(00000233)=0.117135007449212E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 233 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000233)=0.000000000000000E+00 beta (00000234)=0.134181410111357E+02 gamma(00000234)=0.134181410111357E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 234 z1= 1 0.121207868516299E-06 0.000000000000000E+00 z1= 2 -.300841636135642E-02 0.000000000000000E+00 z1= 3 0.315229123370748E-07 0.000000000000000E+00 alpha(00000234)=0.000000000000000E+00 beta (00000235)=0.127029965584488E+02 gamma(00000235)=0.127029965584488E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 235 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000235)=0.000000000000000E+00 beta (00000236)=0.131889496778900E+02 gamma(00000236)=0.131889496778900E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 236 z1= 1 -.126825608948861E-06 0.000000000000000E+00 z1= 2 0.368971255602694E-02 0.000000000000000E+00 z1= 3 -.376705805674605E-07 0.000000000000000E+00 alpha(00000236)=0.000000000000000E+00 beta (00000237)=0.130424586987675E+02 gamma(00000237)=0.130424586987675E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 237 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000237)=0.000000000000000E+00 beta (00000238)=0.136080430443738E+02 gamma(00000238)=0.136080430443738E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 238 z1= 1 0.132788119232979E-06 0.000000000000000E+00 z1= 2 -.399886476438265E-02 0.000000000000000E+00 z1= 3 0.454515095120196E-07 0.000000000000000E+00 alpha(00000238)=0.000000000000000E+00 beta (00000239)=0.127357057833053E+02 gamma(00000239)=0.127357057833053E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 239 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000239)=0.000000000000000E+00 beta (00000240)=0.139160000612643E+02 gamma(00000240)=0.139160000612643E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 240 z1= 1 -.129393817469708E-06 0.000000000000000E+00 z1= 2 0.414401111289811E-02 0.000000000000000E+00 z1= 3 -.458868605101095E-07 0.000000000000000E+00 alpha(00000240)=0.000000000000000E+00 beta (00000241)=0.129912820651744E+02 gamma(00000241)=0.129912820651744E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 241 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000241)=0.000000000000000E+00 beta (00000242)=0.135235888655872E+02 gamma(00000242)=0.135235888655872E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 242 z1= 1 0.135392257750652E-06 0.000000000000000E+00 z1= 2 -.423843049717093E-02 0.000000000000000E+00 z1= 3 0.531686872203008E-07 0.000000000000000E+00 alpha(00000242)=0.000000000000000E+00 beta (00000243)=0.129327812715416E+02 gamma(00000243)=0.129327812715416E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 243 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000243)=0.000000000000000E+00 beta (00000244)=0.132305695799204E+02 gamma(00000244)=0.132305695799204E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 244 z1= 1 -.152101139022295E-06 0.000000000000000E+00 z1= 2 0.419038729903027E-02 0.000000000000000E+00 z1= 3 -.714531606684204E-07 0.000000000000000E+00 alpha(00000244)=0.000000000000000E+00 beta (00000245)=0.126386926478869E+02 gamma(00000245)=0.126386926478869E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 245 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000245)=0.000000000000000E+00 beta (00000246)=0.135992471488952E+02 gamma(00000246)=0.135992471488952E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 246 z1= 1 0.162163459608861E-06 0.000000000000000E+00 z1= 2 -.393030212301772E-02 0.000000000000000E+00 z1= 3 0.880104403164477E-07 0.000000000000000E+00 alpha(00000246)=0.000000000000000E+00 beta (00000247)=0.128188996289938E+02 gamma(00000247)=0.128188996289938E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 247 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000247)=0.000000000000000E+00 beta (00000248)=0.131440859609805E+02 gamma(00000248)=0.131440859609805E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 248 z1= 1 -.175298964410348E-06 0.000000000000000E+00 z1= 2 0.384414991379871E-02 0.000000000000000E+00 z1= 3 -.101780985206591E-06 0.000000000000000E+00 alpha(00000248)=0.000000000000000E+00 beta (00000249)=0.123936882515899E+02 gamma(00000249)=0.123936882515899E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 249 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000249)=0.000000000000000E+00 beta (00000250)=0.131791232606126E+02 gamma(00000250)=0.131791232606126E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 250 z1= 1 0.179162578865626E-06 0.000000000000000E+00 z1= 2 -.356725375355795E-02 0.000000000000000E+00 z1= 3 0.110213132212180E-06 0.000000000000000E+00 alpha(00000250)=0.000000000000000E+00 beta (00000251)=0.127446133194169E+02 gamma(00000251)=0.127446133194169E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 251 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000251)=0.000000000000000E+00 beta (00000252)=0.131600486171875E+02 gamma(00000252)=0.131600486171875E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 252 z1= 1 -.195264993574969E-06 0.000000000000000E+00 z1= 2 0.344839797579433E-02 0.000000000000000E+00 z1= 3 -.127442603211833E-06 0.000000000000000E+00 alpha(00000252)=0.000000000000000E+00 beta (00000253)=0.120942982600456E+02 gamma(00000253)=0.120942982600456E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 253 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000253)=0.000000000000000E+00 beta (00000254)=0.130884903624765E+02 gamma(00000254)=0.130884903624765E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 254 z1= 1 0.205191029706894E-06 0.000000000000000E+00 z1= 2 -.332401113957174E-02 0.000000000000000E+00 z1= 3 0.143229493645416E-06 0.000000000000000E+00 alpha(00000254)=0.000000000000000E+00 beta (00000255)=0.122949781414313E+02 gamma(00000255)=0.122949781414313E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 255 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000255)=0.000000000000000E+00 beta (00000256)=0.133715021262202E+02 gamma(00000256)=0.133715021262202E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 256 z1= 1 -.213161201633848E-06 0.000000000000000E+00 z1= 2 0.309772039664024E-02 0.000000000000000E+00 z1= 3 -.157283040853320E-06 0.000000000000000E+00 alpha(00000256)=0.000000000000000E+00 beta (00000257)=0.126643105893536E+02 gamma(00000257)=0.126643105893536E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 257 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000257)=0.000000000000000E+00 beta (00000258)=0.133399967259350E+02 gamma(00000258)=0.133399967259350E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 258 z1= 1 0.221187078912593E-06 0.000000000000000E+00 z1= 2 -.303372597364101E-02 0.000000000000000E+00 z1= 3 0.168205754335271E-06 0.000000000000000E+00 alpha(00000258)=0.000000000000000E+00 beta (00000259)=0.127509066313474E+02 gamma(00000259)=0.127509066313474E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 259 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000259)=0.000000000000000E+00 beta (00000260)=0.139527188987211E+02 gamma(00000260)=0.139527188987211E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 260 z1= 1 -.216237839089067E-06 0.000000000000000E+00 z1= 2 0.310644864865421E-02 0.000000000000000E+00 z1= 3 -.167832680225471E-06 0.000000000000000E+00 alpha(00000260)=0.000000000000000E+00 beta (00000261)=0.124301986647147E+02 gamma(00000261)=0.124301986647147E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 261 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000261)=0.000000000000000E+00 beta (00000262)=0.133556351354102E+02 gamma(00000262)=0.133556351354102E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 262 z1= 1 0.220234759156553E-06 0.000000000000000E+00 z1= 2 -.326166932677673E-02 0.000000000000000E+00 z1= 3 0.175441176663823E-06 0.000000000000000E+00 alpha(00000262)=0.000000000000000E+00 beta (00000263)=0.132288210304371E+02 gamma(00000263)=0.132288210304371E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 263 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000263)=0.000000000000000E+00 beta (00000264)=0.133124753354833E+02 gamma(00000264)=0.133124753354833E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 264 z1= 1 -.240262124773152E-06 0.000000000000000E+00 z1= 2 0.359794928624082E-02 0.000000000000000E+00 z1= 3 -.197545954799556E-06 0.000000000000000E+00 alpha(00000264)=0.000000000000000E+00 beta (00000265)=0.127892313892851E+02 gamma(00000265)=0.127892313892851E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 265 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000265)=0.000000000000000E+00 beta (00000266)=0.131292666177415E+02 gamma(00000266)=0.131292666177415E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 266 z1= 1 0.253685918740181E-06 0.000000000000000E+00 z1= 2 -.364976482668746E-02 0.000000000000000E+00 z1= 3 0.214839871377640E-06 0.000000000000000E+00 alpha(00000266)=0.000000000000000E+00 beta (00000267)=0.123433192342358E+02 gamma(00000267)=0.123433192342358E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 267 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000267)=0.000000000000000E+00 beta (00000268)=0.133992190229073E+02 gamma(00000268)=0.133992190229073E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 268 z1= 1 -.251898732214241E-06 0.000000000000000E+00 z1= 2 0.355411919842831E-02 0.000000000000000E+00 z1= 3 -.217859680089107E-06 0.000000000000000E+00 alpha(00000268)=0.000000000000000E+00 beta (00000269)=0.122540206192636E+02 gamma(00000269)=0.122540206192636E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 269 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000269)=0.000000000000000E+00 beta (00000270)=0.138495013078486E+02 gamma(00000270)=0.138495013078486E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 270 z1= 1 0.240720128291943E-06 0.000000000000000E+00 z1= 2 -.332258301422788E-02 0.000000000000000E+00 z1= 3 0.211201830553750E-06 0.000000000000000E+00 alpha(00000270)=0.000000000000000E+00 beta (00000271)=0.126404604586458E+02 gamma(00000271)=0.126404604586458E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 271 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000271)=0.000000000000000E+00 beta (00000272)=0.127758968262998E+02 gamma(00000272)=0.127758968262998E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 272 z1= 1 -.256016972793090E-06 0.000000000000000E+00 z1= 2 0.350761311831407E-02 0.000000000000000E+00 z1= 3 -.230059714113363E-06 0.000000000000000E+00 alpha(00000272)=0.000000000000000E+00 beta (00000273)=0.130373752814147E+02 gamma(00000273)=0.130373752814147E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 273 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000273)=0.000000000000000E+00 beta (00000274)=0.133052002307632E+02 gamma(00000274)=0.133052002307632E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 274 z1= 1 0.263283772683649E-06 0.000000000000000E+00 z1= 2 -.365673941158323E-02 0.000000000000000E+00 z1= 3 0.241388019817015E-06 0.000000000000000E+00 alpha(00000274)=0.000000000000000E+00 beta (00000275)=0.120070772636158E+02 gamma(00000275)=0.120070772636158E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 275 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000275)=0.000000000000000E+00 beta (00000276)=0.134357571321985E+02 gamma(00000276)=0.134357571321985E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 276 z1= 1 -.243326090789385E-06 0.000000000000000E+00 z1= 2 0.340640682403458E-02 0.000000000000000E+00 z1= 3 -.226941366454712E-06 0.000000000000000E+00 alpha(00000276)=0.000000000000000E+00 beta (00000277)=0.124719582080339E+02 gamma(00000277)=0.124719582080339E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 277 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000277)=0.000000000000000E+00 beta (00000278)=0.139892505619618E+02 gamma(00000278)=0.139892505619618E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 278 z1= 1 0.227441024965025E-06 0.000000000000000E+00 z1= 2 -.295148869623912E-02 0.000000000000000E+00 z1= 3 0.212765496897076E-06 0.000000000000000E+00 alpha(00000278)=0.000000000000000E+00 beta (00000279)=0.123300700390088E+02 gamma(00000279)=0.123300700390088E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 279 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000279)=0.000000000000000E+00 beta (00000280)=0.130515654447147E+02 gamma(00000280)=0.130515654447147E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 280 z1= 1 -.224679976992305E-06 0.000000000000000E+00 z1= 2 0.300531960882153E-02 0.000000000000000E+00 z1= 3 -.211713138847415E-06 0.000000000000000E+00 alpha(00000280)=0.000000000000000E+00 beta (00000281)=0.131138169907522E+02 gamma(00000281)=0.131138169907522E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 281 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000281)=0.000000000000000E+00 beta (00000282)=0.137452098399920E+02 gamma(00000282)=0.137452098399920E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 282 z1= 1 0.226013177370959E-06 0.000000000000000E+00 z1= 2 -.295112879543187E-02 0.000000000000000E+00 z1= 3 0.213129837820609E-06 0.000000000000000E+00 alpha(00000282)=0.000000000000000E+00 beta (00000283)=0.122834710914590E+02 gamma(00000283)=0.122834710914590E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 283 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000283)=0.000000000000000E+00 beta (00000284)=0.130403399389155E+02 gamma(00000284)=0.130403399389155E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 284 z1= 1 -.221688823908404E-06 0.000000000000000E+00 z1= 2 0.290276304139346E-02 0.000000000000000E+00 z1= 3 -.212622606101309E-06 0.000000000000000E+00 alpha(00000284)=0.000000000000000E+00 beta (00000285)=0.127520462043194E+02 gamma(00000285)=0.127520462043194E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 285 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000285)=0.000000000000000E+00 beta (00000286)=0.136892444715148E+02 gamma(00000286)=0.136892444715148E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 286 z1= 1 0.213677187248110E-06 0.000000000000000E+00 z1= 2 -.294582396583691E-02 0.000000000000000E+00 z1= 3 0.205635273337708E-06 0.000000000000000E+00 alpha(00000286)=0.000000000000000E+00 beta (00000287)=0.124621256146337E+02 gamma(00000287)=0.124621256146337E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 287 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000287)=0.000000000000000E+00 beta (00000288)=0.131292906326655E+02 gamma(00000288)=0.131292906326655E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 288 z1= 1 -.212996721875476E-06 0.000000000000000E+00 z1= 2 0.289136672806346E-02 0.000000000000000E+00 z1= 3 -.210383393196151E-06 0.000000000000000E+00 alpha(00000288)=0.000000000000000E+00 beta (00000289)=0.122916707087580E+02 gamma(00000289)=0.122916707087580E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 289 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000289)=0.000000000000000E+00 beta (00000290)=0.136575447201270E+02 gamma(00000290)=0.136575447201270E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 290 z1= 1 0.197884088625833E-06 0.000000000000000E+00 z1= 2 -.270176863747180E-02 0.000000000000000E+00 z1= 3 0.195033417209572E-06 0.000000000000000E+00 alpha(00000290)=0.000000000000000E+00 beta (00000291)=0.125950853223292E+02 gamma(00000291)=0.125950853223292E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 291 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000291)=0.000000000000000E+00 beta (00000292)=0.133893094372564E+02 gamma(00000292)=0.133893094372564E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 292 z1= 1 -.183898297310406E-06 0.000000000000000E+00 z1= 2 0.264557757730714E-02 0.000000000000000E+00 z1= 3 -.188080456217242E-06 0.000000000000000E+00 alpha(00000292)=0.000000000000000E+00 beta (00000293)=0.127976284179451E+02 gamma(00000293)=0.127976284179451E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 293 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000293)=0.000000000000000E+00 beta (00000294)=0.131697464331787E+02 gamma(00000294)=0.131697464331787E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 294 z1= 1 0.180626868016495E-06 0.000000000000000E+00 z1= 2 -.244228358055100E-02 0.000000000000000E+00 z1= 3 0.181042830854779E-06 0.000000000000000E+00 alpha(00000294)=0.000000000000000E+00 beta (00000295)=0.123357794480127E+02 gamma(00000295)=0.123357794480127E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 295 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000295)=0.000000000000000E+00 beta (00000296)=0.133764946926037E+02 gamma(00000296)=0.133764946926037E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 296 z1= 1 -.171613128294645E-06 0.000000000000000E+00 z1= 2 0.203857868887902E-02 0.000000000000000E+00 z1= 3 -.181596422468519E-06 0.000000000000000E+00 alpha(00000296)=0.000000000000000E+00 beta (00000297)=0.128342718547400E+02 gamma(00000297)=0.128342718547400E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 297 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000297)=0.000000000000000E+00 beta (00000298)=0.133562981189847E+02 gamma(00000298)=0.133562981189847E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 298 z1= 1 0.178533113301751E-06 0.000000000000000E+00 z1= 2 -.198412026851934E-02 0.000000000000000E+00 z1= 3 0.179564433733259E-06 0.000000000000000E+00 alpha(00000298)=0.000000000000000E+00 beta (00000299)=0.123710358108887E+02 gamma(00000299)=0.123710358108887E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 299 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000299)=0.000000000000000E+00 beta (00000300)=0.131761184459341E+02 gamma(00000300)=0.131761184459341E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 300 z1= 1 -.159486714811910E-06 0.000000000000000E+00 z1= 2 0.213220287467766E-02 0.000000000000000E+00 z1= 3 -.173549806904011E-06 0.000000000000000E+00 alpha(00000300)=0.000000000000000E+00 beta (00000301)=0.121904162822011E+02 gamma(00000301)=0.121904162822011E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 301 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000301)=0.000000000000000E+00 beta (00000302)=0.140990654056431E+02 gamma(00000302)=0.140990654056431E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 302 z1= 1 0.141105900022418E-06 0.000000000000000E+00 z1= 2 -.226204588394485E-02 0.000000000000000E+00 z1= 3 0.131954751010892E-06 0.000000000000000E+00 alpha(00000302)=0.000000000000000E+00 beta (00000303)=0.131697578240761E+02 gamma(00000303)=0.131697578240761E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 303 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000303)=0.000000000000000E+00 beta (00000304)=0.138340038956644E+02 gamma(00000304)=0.138340038956644E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 304 z1= 1 -.120151629236231E-06 0.000000000000000E+00 z1= 2 0.246813608205626E-02 0.000000000000000E+00 z1= 3 -.133910881224540E-06 0.000000000000000E+00 alpha(00000304)=0.000000000000000E+00 beta (00000305)=0.122203748295188E+02 gamma(00000305)=0.122203748295188E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 305 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000305)=0.000000000000000E+00 beta (00000306)=0.137010740535499E+02 gamma(00000306)=0.137010740535499E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 306 z1= 1 0.121536345426467E-06 0.000000000000000E+00 z1= 2 -.228402034896161E-02 0.000000000000000E+00 z1= 3 0.110664236999711E-06 0.000000000000000E+00 alpha(00000306)=0.000000000000000E+00 beta (00000307)=0.128777335207365E+02 gamma(00000307)=0.128777335207365E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 307 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000307)=0.000000000000000E+00 beta (00000308)=0.131060266248951E+02 gamma(00000308)=0.131060266248951E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 308 z1= 1 -.107561945637651E-06 0.000000000000000E+00 z1= 2 0.236517676083713E-02 0.000000000000000E+00 z1= 3 -.121794952008579E-06 0.000000000000000E+00 alpha(00000308)=0.000000000000000E+00 beta (00000309)=0.125804439217250E+02 gamma(00000309)=0.125804439217250E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 309 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000309)=0.000000000000000E+00 beta (00000310)=0.132513405147345E+02 gamma(00000310)=0.132513405147345E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 310 z1= 1 0.112812103814346E-06 0.000000000000000E+00 z1= 2 -.260841718465858E-02 0.000000000000000E+00 z1= 3 0.969492487958804E-07 0.000000000000000E+00 alpha(00000310)=0.000000000000000E+00 beta (00000311)=0.124350205959703E+02 gamma(00000311)=0.124350205959703E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 311 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000311)=0.000000000000000E+00 beta (00000312)=0.124506746973548E+02 gamma(00000312)=0.124506746973548E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 312 z1= 1 -.923774893634832E-07 0.000000000000000E+00 z1= 2 0.281676931963723E-02 0.000000000000000E+00 z1= 3 -.111075559670187E-06 0.000000000000000E+00 alpha(00000312)=0.000000000000000E+00 beta (00000313)=0.127901502506900E+02 gamma(00000313)=0.127901502506900E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 313 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000313)=0.000000000000000E+00 beta (00000314)=0.135113051722139E+02 gamma(00000314)=0.135113051722139E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 314 z1= 1 0.105802041429608E-06 0.000000000000000E+00 z1= 2 -.292533925993294E-02 0.000000000000000E+00 z1= 3 0.703040372592540E-07 0.000000000000000E+00 alpha(00000314)=0.000000000000000E+00 beta (00000315)=0.127484485595537E+02 gamma(00000315)=0.127484485595537E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 315 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000315)=0.000000000000000E+00 beta (00000316)=0.137243297494473E+02 gamma(00000316)=0.137243297494473E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 316 z1= 1 -.640892616615707E-07 0.000000000000000E+00 z1= 2 0.276918539324078E-02 0.000000000000000E+00 z1= 3 -.101573845591777E-06 0.000000000000000E+00 alpha(00000316)=0.000000000000000E+00 beta (00000317)=0.131081639242513E+02 gamma(00000317)=0.131081639242513E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 317 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000317)=0.000000000000000E+00 beta (00000318)=0.134870596862999E+02 gamma(00000318)=0.134870596862999E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 318 z1= 1 0.968809334915121E-07 0.000000000000000E+00 z1= 2 -.261226576810527E-02 0.000000000000000E+00 z1= 3 0.527056508851150E-07 0.000000000000000E+00 alpha(00000318)=0.000000000000000E+00 beta (00000319)=0.121494753970518E+02 gamma(00000319)=0.121494753970518E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 319 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000319)=0.000000000000000E+00 beta (00000320)=0.135542864226880E+02 gamma(00000320)=0.135542864226880E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 320 z1= 1 -.376218986515402E-07 0.000000000000000E+00 z1= 2 0.224046791236988E-02 0.000000000000000E+00 z1= 3 -.910840583320414E-07 0.000000000000000E+00 alpha(00000320)=0.000000000000000E+00 beta (00000321)=0.121594661184811E+02 gamma(00000321)=0.121594661184811E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 321 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000321)=0.000000000000000E+00 beta (00000322)=0.136261636900429E+02 gamma(00000322)=0.136261636900429E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 322 z1= 1 0.831615635713380E-07 0.000000000000000E+00 z1= 2 -.169300917024301E-02 0.000000000000000E+00 z1= 3 0.234354084632273E-07 0.000000000000000E+00 alpha(00000322)=0.000000000000000E+00 beta (00000323)=0.130734213669156E+02 gamma(00000323)=0.130734213669156E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 323 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000323)=0.000000000000000E+00 beta (00000324)=0.140594436582100E+02 gamma(00000324)=0.140594436582100E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 324 z1= 1 -.165197236413287E-08 0.000000000000000E+00 z1= 2 0.131475428914379E-02 0.000000000000000E+00 z1= 3 -.820473729718548E-07 0.000000000000000E+00 alpha(00000324)=0.000000000000000E+00 beta (00000325)=0.121886674743560E+02 gamma(00000325)=0.121886674743560E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 325 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000325)=0.000000000000000E+00 beta (00000326)=0.137714423932144E+02 gamma(00000326)=0.137714423932144E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 326 z1= 1 0.562481963096561E-07 0.000000000000000E+00 z1= 2 -.984075625035748E-03 0.000000000000000E+00 z1= 3 -.128913143410451E-07 0.000000000000000E+00 alpha(00000326)=0.000000000000000E+00 beta (00000327)=0.131355428511009E+02 gamma(00000327)=0.131355428511009E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 327 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000327)=0.000000000000000E+00 beta (00000328)=0.142204729777626E+02 gamma(00000328)=0.142204729777626E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 328 z1= 1 0.204936731856538E-07 0.000000000000000E+00 z1= 2 0.906573210488800E-03 0.000000000000000E+00 z1= 3 -.523764775168102E-07 0.000000000000000E+00 alpha(00000328)=0.000000000000000E+00 beta (00000329)=0.120145343285485E+02 gamma(00000329)=0.120145343285485E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 329 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000329)=0.000000000000000E+00 beta (00000330)=0.137577031724546E+02 gamma(00000330)=0.137577031724546E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 330 z1= 1 0.162379384270801E-07 0.000000000000000E+00 z1= 2 -.104524172959412E-02 0.000000000000000E+00 z1= 3 -.304662731985571E-07 0.000000000000000E+00 alpha(00000330)=0.000000000000000E+00 beta (00000331)=0.125219550645678E+02 gamma(00000331)=0.125219550645678E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 331 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000331)=0.000000000000000E+00 beta (00000332)=0.129184575409053E+02 gamma(00000332)=0.129184575409053E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 332 z1= 1 0.451937267990921E-07 0.000000000000000E+00 z1= 2 0.139984975860834E-02 0.000000000000000E+00 z1= 3 0.628147862845037E-08 0.000000000000000E+00 alpha(00000332)=0.000000000000000E+00 beta (00000333)=0.123345896714392E+02 gamma(00000333)=0.123345896714392E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 333 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000333)=0.000000000000000E+00 beta (00000334)=0.140504811821687E+02 gamma(00000334)=0.140504811821687E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 334 z1= 1 -.231562756884446E-07 0.000000000000000E+00 z1= 2 -.150813289761036E-02 0.000000000000000E+00 z1= 3 -.618058268854829E-07 0.000000000000000E+00 alpha(00000334)=0.000000000000000E+00 beta (00000335)=0.124129958117827E+02 gamma(00000335)=0.124129958117827E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 335 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000335)=0.000000000000000E+00 beta (00000336)=0.136575769948113E+02 gamma(00000336)=0.136575769948113E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 336 z1= 1 0.660313095237491E-07 0.000000000000000E+00 z1= 2 0.151953506402204E-02 0.000000000000000E+00 z1= 3 0.440538278456926E-07 0.000000000000000E+00 alpha(00000336)=0.000000000000000E+00 beta (00000337)=0.130744403467749E+02 gamma(00000337)=0.130744403467749E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 337 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000337)=0.000000000000000E+00 beta (00000338)=0.124898232252264E+02 gamma(00000338)=0.124898232252264E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 338 z1= 1 -.502180605304085E-07 0.000000000000000E+00 z1= 2 -.143397436229731E-02 0.000000000000000E+00 z1= 3 -.848265709592827E-07 0.000000000000000E+00 alpha(00000338)=0.000000000000000E+00 beta (00000339)=0.126887548844265E+02 gamma(00000339)=0.126887548844265E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 339 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000339)=0.000000000000000E+00 beta (00000340)=0.140007415266453E+02 gamma(00000340)=0.140007415266453E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 340 z1= 1 0.676998179613636E-07 0.000000000000000E+00 z1= 2 0.119202780888366E-02 0.000000000000000E+00 z1= 3 0.538691174564509E-07 0.000000000000000E+00 alpha(00000340)=0.000000000000000E+00 beta (00000341)=0.128537075078851E+02 gamma(00000341)=0.128537075078851E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 341 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000341)=0.000000000000000E+00 beta (00000342)=0.135534469988138E+02 gamma(00000342)=0.135534469988138E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 342 z1= 1 -.530330567287353E-07 0.000000000000000E+00 z1= 2 -.991689936599016E-03 0.000000000000000E+00 z1= 3 -.771450509420008E-07 0.000000000000000E+00 alpha(00000342)=0.000000000000000E+00 beta (00000343)=0.129413445350190E+02 gamma(00000343)=0.129413445350190E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 343 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000343)=0.000000000000000E+00 beta (00000344)=0.129003330528723E+02 gamma(00000344)=0.129003330528723E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 344 z1= 1 0.810042134482859E-07 0.000000000000000E+00 z1= 2 0.587537914705734E-03 0.000000000000000E+00 z1= 3 0.720238992710981E-07 0.000000000000000E+00 alpha(00000344)=0.000000000000000E+00 beta (00000345)=0.125985258986560E+02 gamma(00000345)=0.125985258986560E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 345 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000345)=0.000000000000000E+00 beta (00000346)=0.138655207151318E+02 gamma(00000346)=0.138655207151318E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 346 z1= 1 -.769392061415538E-07 0.000000000000000E+00 z1= 2 -.183947621417854E-03 0.000000000000000E+00 z1= 3 -.857464788675126E-07 0.000000000000000E+00 alpha(00000346)=0.000000000000000E+00 beta (00000347)=0.127179593704868E+02 gamma(00000347)=0.127179593704868E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 347 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000347)=0.000000000000000E+00 beta (00000348)=0.132980285695248E+02 gamma(00000348)=0.132980285695248E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 348 z1= 1 0.853569675756261E-07 0.000000000000000E+00 z1= 2 -.315311204698579E-03 0.000000000000000E+00 z1= 3 0.781732153861550E-07 0.000000000000000E+00 alpha(00000348)=0.000000000000000E+00 beta (00000349)=0.126905270296192E+02 gamma(00000349)=0.126905270296192E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 349 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000349)=0.000000000000000E+00 beta (00000350)=0.134152307916205E+02 gamma(00000350)=0.134152307916205E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 350 z1= 1 -.816210237886020E-07 0.000000000000000E+00 z1= 2 0.856052410235812E-03 0.000000000000000E+00 z1= 3 -.733286703410898E-07 0.000000000000000E+00 alpha(00000350)=0.000000000000000E+00 beta (00000351)=0.123517069252362E+02 gamma(00000351)=0.123517069252362E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 351 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000351)=0.000000000000000E+00 beta (00000352)=0.134007264356844E+02 gamma(00000352)=0.134007264356844E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 352 z1= 1 0.709642021422458E-07 0.000000000000000E+00 z1= 2 -.144479093597454E-02 0.000000000000000E+00 z1= 3 0.643011977330464E-07 0.000000000000000E+00 alpha(00000352)=0.000000000000000E+00 beta (00000353)=0.118190031015431E+02 gamma(00000353)=0.118190031015431E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 353 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000353)=0.000000000000000E+00 beta (00000354)=0.125676244038889E+02 gamma(00000354)=0.125676244038889E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 354 z1= 1 -.793022805811510E-07 0.000000000000000E+00 z1= 2 0.188787164755680E-02 0.000000000000000E+00 z1= 3 -.543043083235043E-07 0.000000000000000E+00 alpha(00000354)=0.000000000000000E+00 beta (00000355)=0.124082453159207E+02 gamma(00000355)=0.124082453159207E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 355 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000355)=0.000000000000000E+00 beta (00000356)=0.130850530839462E+02 gamma(00000356)=0.130850530839462E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 356 z1= 1 0.693957810974592E-07 0.000000000000000E+00 z1= 2 -.213031537600590E-02 0.000000000000000E+00 z1= 3 0.784487207602371E-07 0.000000000000000E+00 alpha(00000356)=0.000000000000000E+00 beta (00000357)=0.124724531562940E+02 gamma(00000357)=0.124724531562940E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 357 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000357)=0.000000000000000E+00 beta (00000358)=0.136592680031335E+02 gamma(00000358)=0.136592680031335E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 358 z1= 1 -.923998972925653E-07 0.000000000000000E+00 z1= 2 0.230579518840444E-02 0.000000000000000E+00 z1= 3 -.446914959688989E-07 0.000000000000000E+00 alpha(00000358)=0.000000000000000E+00 beta (00000359)=0.127158959092198E+02 gamma(00000359)=0.127158959092198E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 359 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000359)=0.000000000000000E+00 beta (00000360)=0.141506921156514E+02 gamma(00000360)=0.141506921156514E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 360 z1= 1 0.415458019207443E-07 0.000000000000000E+00 z1= 2 -.221080640643615E-02 0.000000000000000E+00 z1= 3 0.740068452159627E-07 0.000000000000000E+00 alpha(00000360)=0.000000000000000E+00 beta (00000361)=0.123981644377562E+02 gamma(00000361)=0.123981644377562E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 361 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000361)=0.000000000000000E+00 beta (00000362)=0.136947404357386E+02 gamma(00000362)=0.136947404357386E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 362 z1= 1 -.841100262200358E-07 0.000000000000000E+00 z1= 2 0.182297556417132E-02 0.000000000000000E+00 z1= 3 -.207998997314295E-07 0.000000000000000E+00 alpha(00000362)=0.000000000000000E+00 beta (00000363)=0.120954448521912E+02 gamma(00000363)=0.120954448521912E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 363 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000363)=0.000000000000000E+00 beta (00000364)=0.137325652328457E+02 gamma(00000364)=0.137325652328457E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 364 z1= 1 0.203328122316479E-07 0.000000000000000E+00 z1= 2 -.126612509489056E-02 0.000000000000000E+00 z1= 3 0.722771994629231E-07 0.000000000000000E+00 alpha(00000364)=0.000000000000000E+00 beta (00000365)=0.130218248498709E+02 gamma(00000365)=0.130218248498709E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 365 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000365)=0.000000000000000E+00 beta (00000366)=0.136367787697311E+02 gamma(00000366)=0.136367787697311E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 366 z1= 1 -.877905079008524E-07 0.000000000000000E+00 z1= 2 0.636461625198625E-03 0.000000000000000E+00 z1= 3 -.154313352400599E-07 0.000000000000000E+00 alpha(00000366)=0.000000000000000E+00 beta (00000367)=0.128318873933847E+02 gamma(00000367)=0.128318873933847E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 367 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000367)=0.000000000000000E+00 beta (00000368)=0.129446267098744E+02 gamma(00000368)=0.129446267098744E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 368 z1= 1 0.263490312277237E-07 0.000000000000000E+00 z1= 2 0.130652074029642E-03 0.000000000000000E+00 z1= 3 0.926406119797349E-07 0.000000000000000E+00 alpha(00000368)=0.000000000000000E+00 beta (00000369)=0.124662645294218E+02 gamma(00000369)=0.124662645294218E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 369 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000369)=0.000000000000000E+00 beta (00000370)=0.134901648606571E+02 gamma(00000370)=0.134901648606571E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 370 z1= 1 -.104622343416070E-06 0.000000000000000E+00 z1= 2 -.567739184831720E-03 0.000000000000000E+00 z1= 3 -.311921617921211E-07 0.000000000000000E+00 alpha(00000370)=0.000000000000000E+00 beta (00000371)=0.122171546305227E+02 gamma(00000371)=0.122171546305227E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 371 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000371)=0.000000000000000E+00 beta (00000372)=0.133962258219935E+02 gamma(00000372)=0.133962258219935E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 372 z1= 1 0.827185642909584E-08 0.000000000000000E+00 z1= 2 0.115036481346467E-02 0.000000000000000E+00 z1= 3 0.125877538265323E-06 0.000000000000000E+00 alpha(00000372)=0.000000000000000E+00 beta (00000373)=0.126979286902324E+02 gamma(00000373)=0.126979286902324E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 373 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000373)=0.000000000000000E+00 beta (00000374)=0.129033476840709E+02 gamma(00000374)=0.129033476840709E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 374 z1= 1 -.131022305350278E-06 0.000000000000000E+00 z1= 2 -.198362074397239E-02 0.000000000000000E+00 z1= 3 -.783137126859641E-08 0.000000000000000E+00 alpha(00000374)=0.000000000000000E+00 beta (00000375)=0.125750892555999E+02 gamma(00000375)=0.125750892555999E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 375 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000375)=0.000000000000000E+00 beta (00000376)=0.134805920586617E+02 gamma(00000376)=0.134805920586617E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 376 z1= 1 -.440515287752127E-07 0.000000000000000E+00 z1= 2 0.272254948301085E-02 0.000000000000000E+00 z1= 3 0.176570352278813E-06 0.000000000000000E+00 alpha(00000376)=0.000000000000000E+00 beta (00000377)=0.124205285911790E+02 gamma(00000377)=0.124205285911790E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 377 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000377)=0.000000000000000E+00 beta (00000378)=0.135305098195932E+02 gamma(00000378)=0.135305098195932E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 378 z1= 1 -.195649761935372E-06 0.000000000000000E+00 z1= 2 -.329897909866543E-02 0.000000000000000E+00 z1= 3 0.555560926689819E-07 0.000000000000000E+00 alpha(00000378)=0.000000000000000E+00 beta (00000379)=0.123571279120983E+02 gamma(00000379)=0.123571279120983E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 379 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000379)=0.000000000000000E+00 beta (00000380)=0.136909119290502E+02 gamma(00000380)=0.136909119290502E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 380 z1= 1 -.133849149213435E-06 0.000000000000000E+00 z1= 2 0.339383775875798E-02 0.000000000000000E+00 z1= 3 0.255313600154637E-06 0.000000000000000E+00 alpha(00000380)=0.000000000000000E+00 beta (00000381)=0.124537549577472E+02 gamma(00000381)=0.124537549577472E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 381 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000381)=0.000000000000000E+00 beta (00000382)=0.125432761357185E+02 gamma(00000382)=0.125432761357185E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 382 z1= 1 -.306471174983192E-06 0.000000000000000E+00 z1= 2 -.361287106511905E-02 0.000000000000000E+00 z1= 3 0.185448945689854E-06 0.000000000000000E+00 alpha(00000382)=0.000000000000000E+00 beta (00000383)=0.125869195042997E+02 gamma(00000383)=0.125869195042997E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 383 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000383)=0.000000000000000E+00 beta (00000384)=0.136794907965789E+02 gamma(00000384)=0.136794907965789E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 384 z1= 1 -.350416375655615E-06 0.000000000000000E+00 z1= 2 0.334036290393334E-02 0.000000000000000E+00 z1= 3 0.432002511824487E-06 0.000000000000000E+00 alpha(00000384)=0.000000000000000E+00 beta (00000385)=0.122804510198434E+02 gamma(00000385)=0.122804510198434E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 385 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000385)=0.000000000000000E+00 beta (00000386)=0.138878870746363E+02 gamma(00000386)=0.138878870746363E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 386 z1= 1 -.562800139175795E-06 0.000000000000000E+00 z1= 2 -.280632284504053E-02 0.000000000000000E+00 z1= 3 0.478815821349757E-06 0.000000000000000E+00 alpha(00000386)=0.000000000000000E+00 beta (00000387)=0.128121949527822E+02 gamma(00000387)=0.128121949527822E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 387 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000387)=0.000000000000000E+00 beta (00000388)=0.141636947477122E+02 gamma(00000388)=0.141636947477122E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 388 z1= 1 -.575804125055659E-06 0.000000000000000E+00 z1= 2 0.237866067104573E-02 0.000000000000000E+00 z1= 3 0.616572929833508E-06 0.000000000000000E+00 alpha(00000388)=0.000000000000000E+00 beta (00000389)=0.122885000398740E+02 gamma(00000389)=0.122885000398740E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 389 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000389)=0.000000000000000E+00 beta (00000390)=0.129045351762472E+02 gamma(00000390)=0.129045351762472E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 390 z1= 1 -.672608680526727E-06 0.000000000000000E+00 z1= 2 -.231175419742300E-02 0.000000000000000E+00 z1= 3 0.620530431003270E-06 0.000000000000000E+00 alpha(00000390)=0.000000000000000E+00 beta (00000391)=0.137010807513121E+02 gamma(00000391)=0.137010807513121E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 391 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000391)=0.000000000000000E+00 beta (00000392)=0.134764813983287E+02 gamma(00000392)=0.134764813983287E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 392 z1= 1 -.647610271931401E-06 0.000000000000000E+00 z1= 2 0.247740517718491E-02 0.000000000000000E+00 z1= 3 0.672437520701807E-06 0.000000000000000E+00 alpha(00000392)=0.000000000000000E+00 beta (00000393)=0.127403652187405E+02 gamma(00000393)=0.127403652187405E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 393 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000393)=0.000000000000000E+00 beta (00000394)=0.130704458617977E+02 gamma(00000394)=0.130704458617977E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 394 z1= 1 -.648425207261339E-06 0.000000000000000E+00 z1= 2 -.250446736689609E-02 0.000000000000000E+00 z1= 3 0.615948758051757E-06 0.000000000000000E+00 alpha(00000394)=0.000000000000000E+00 beta (00000395)=0.133731105149478E+02 gamma(00000395)=0.133731105149478E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 395 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000395)=0.000000000000000E+00 beta (00000396)=0.136848042607253E+02 gamma(00000396)=0.136848042607253E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 396 z1= 1 -.558405680832789E-06 0.000000000000000E+00 z1= 2 0.250501541290296E-02 0.000000000000000E+00 z1= 3 0.574967717277769E-06 0.000000000000000E+00 alpha(00000396)=0.000000000000000E+00 beta (00000397)=0.116029967630141E+02 gamma(00000397)=0.116029967630141E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 397 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000397)=0.000000000000000E+00 beta (00000398)=0.143230338323858E+02 gamma(00000398)=0.143230338323858E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 398 z1= 1 -.554769200930864E-06 0.000000000000000E+00 z1= 2 -.202914035517533E-02 0.000000000000000E+00 z1= 3 0.532084697582743E-06 0.000000000000000E+00 alpha(00000398)=0.000000000000000E+00 beta (00000399)=0.132751908096805E+02 gamma(00000399)=0.132751908096805E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 399 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000399)=0.000000000000000E+00 beta (00000400)=0.134992918027318E+02 gamma(00000400)=0.134992918027318E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 400 z1= 1 -.398960628816922E-06 0.000000000000000E+00 z1= 2 0.196989769579348E-02 0.000000000000000E+00 z1= 3 0.401621994864819E-06 0.000000000000000E+00 alpha(00000400)=0.000000000000000E+00 beta (00000401)=0.124695722185232E+02 gamma(00000401)=0.124695722185232E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 401 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000401)=0.000000000000000E+00 beta (00000402)=0.132658427825856E+02 gamma(00000402)=0.132658427825856E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 402 z1= 1 -.249085291568205E-06 0.000000000000000E+00 z1= 2 -.184844531244315E-02 0.000000000000000E+00 z1= 3 0.269760018665197E-06 0.000000000000000E+00 alpha(00000402)=0.000000000000000E+00 beta (00000403)=0.124150178865939E+02 gamma(00000403)=0.124150178865939E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 403 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000403)=0.000000000000000E+00 beta (00000404)=0.134286692157254E+02 gamma(00000404)=0.134286692157254E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 404 z1= 1 -.160978526095356E-06 0.000000000000000E+00 z1= 2 0.181011105851329E-02 0.000000000000000E+00 z1= 3 0.137667609678466E-06 0.000000000000000E+00 alpha(00000404)=0.000000000000000E+00 beta (00000405)=0.125540245340282E+02 gamma(00000405)=0.125540245340282E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 405 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000405)=0.000000000000000E+00 beta (00000406)=0.137004702945635E+02 gamma(00000406)=0.137004702945635E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 406 z1= 1 -.289369222205866E-07 0.000000000000000E+00 z1= 2 -.147629674860473E-02 0.000000000000000E+00 z1= 3 0.104046167371911E-06 0.000000000000000E+00 alpha(00000406)=0.000000000000000E+00 beta (00000407)=0.123087920656160E+02 gamma(00000407)=0.123087920656160E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 407 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000407)=0.000000000000000E+00 beta (00000408)=0.130891101666248E+02 gamma(00000408)=0.130891101666248E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 408 z1= 1 0.148027335402333E-07 0.000000000000000E+00 z1= 2 0.947321275611924E-03 0.000000000000000E+00 z1= 3 -.581839922242800E-07 0.000000000000000E+00 alpha(00000408)=0.000000000000000E+00 beta (00000409)=0.128494855494673E+02 gamma(00000409)=0.128494855494673E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 409 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000409)=0.000000000000000E+00 beta (00000410)=0.135208431976433E+02 gamma(00000410)=0.135208431976433E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 410 z1= 1 0.146707902515600E-06 0.000000000000000E+00 z1= 2 -.625488957471560E-03 0.000000000000000E+00 z1= 3 -.651304696754756E-07 0.000000000000000E+00 alpha(00000410)=0.000000000000000E+00 beta (00000411)=0.121544589668779E+02 gamma(00000411)=0.121544589668779E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 411 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000411)=0.000000000000000E+00 beta (00000412)=0.135053814102775E+02 gamma(00000412)=0.135053814102775E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 412 z1= 1 0.214485701015331E-06 0.000000000000000E+00 z1= 2 0.295026601245059E-03 0.000000000000000E+00 z1= 3 -.229197922349761E-06 0.000000000000000E+00 alpha(00000412)=0.000000000000000E+00 beta (00000413)=0.129428142964866E+02 gamma(00000413)=0.129428142964866E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 413 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000413)=0.000000000000000E+00 beta (00000414)=0.129812480459988E+02 gamma(00000414)=0.129812480459988E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 414 z1= 1 0.358037249455906E-06 0.000000000000000E+00 z1= 2 -.865166287092804E-04 0.000000000000000E+00 z1= 3 -.237763649483429E-06 0.000000000000000E+00 alpha(00000414)=0.000000000000000E+00 beta (00000415)=0.121111371650578E+02 gamma(00000415)=0.121111371650578E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 415 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000415)=0.000000000000000E+00 beta (00000416)=0.134040950753417E+02 gamma(00000416)=0.134040950753417E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 416 z1= 1 0.497507960961832E-06 0.000000000000000E+00 z1= 2 0.539405428773656E-05 0.000000000000000E+00 z1= 3 -.488803598339008E-06 0.000000000000000E+00 alpha(00000416)=0.000000000000000E+00 beta (00000417)=0.128914741035618E+02 gamma(00000417)=0.128914741035618E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 417 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000417)=0.000000000000000E+00 beta (00000418)=0.127797662816464E+02 gamma(00000418)=0.127797662816464E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 418 z1= 1 0.763150805584579E-06 0.000000000000000E+00 z1= 2 -.160754124073163E-03 0.000000000000000E+00 z1= 3 -.580033811962586E-06 0.000000000000000E+00 alpha(00000418)=0.000000000000000E+00 beta (00000419)=0.129207397079089E+02 gamma(00000419)=0.129207397079089E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 419 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000419)=0.000000000000000E+00 beta (00000420)=0.131964867303535E+02 gamma(00000420)=0.131964867303535E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 420 z1= 1 0.100558909315847E-05 0.000000000000000E+00 z1= 2 0.298595334587165E-03 0.000000000000000E+00 z1= 3 -.919211687209045E-06 0.000000000000000E+00 alpha(00000420)=0.000000000000000E+00 beta (00000421)=0.121651346444410E+02 gamma(00000421)=0.121651346444410E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 421 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000421)=0.000000000000000E+00 beta (00000422)=0.132365987353702E+02 gamma(00000422)=0.132365987353702E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 422 z1= 1 0.152596040015485E-05 0.000000000000000E+00 z1= 2 -.326350659419145E-03 0.000000000000000E+00 z1= 3 -.127725369074728E-05 0.000000000000000E+00 alpha(00000422)=0.000000000000000E+00 beta (00000423)=0.127611585266698E+02 gamma(00000423)=0.127611585266698E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 423 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000423)=0.000000000000000E+00 beta (00000424)=0.134154953799594E+02 gamma(00000424)=0.134154953799594E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 424 z1= 1 0.210377106494913E-05 0.000000000000000E+00 z1= 2 0.150495808301370E-03 0.000000000000000E+00 z1= 3 -.183155489737533E-05 0.000000000000000E+00 alpha(00000424)=0.000000000000000E+00 beta (00000425)=0.129349283785150E+02 gamma(00000425)=0.129349283785150E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 425 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000425)=0.000000000000000E+00 beta (00000426)=0.131249901927968E+02 gamma(00000426)=0.131249901927968E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 426 z1= 1 0.263693125392324E-05 0.000000000000000E+00 z1= 2 -.406347710478357E-04 0.000000000000000E+00 z1= 3 -.225287085278475E-05 0.000000000000000E+00 alpha(00000426)=0.000000000000000E+00 beta (00000427)=0.128367433742787E+02 gamma(00000427)=0.128367433742787E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 427 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000427)=0.000000000000000E+00 beta (00000428)=0.138898067923009E+02 gamma(00000428)=0.138898067923009E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 428 z1= 1 0.314593149347044E-05 0.000000000000000E+00 z1= 2 0.776662106963324E-04 0.000000000000000E+00 z1= 3 -.269771218886134E-05 0.000000000000000E+00 alpha(00000428)=0.000000000000000E+00 beta (00000429)=0.130173091755508E+02 gamma(00000429)=0.130173091755508E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 429 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000429)=0.000000000000000E+00 beta (00000430)=0.131867730944051E+02 gamma(00000430)=0.131867730944051E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 430 z1= 1 0.309514295358153E-05 0.000000000000000E+00 z1= 2 -.339711709519119E-03 0.000000000000000E+00 z1= 3 -.269411914462551E-05 0.000000000000000E+00 alpha(00000430)=0.000000000000000E+00 beta (00000431)=0.121392851978464E+02 gamma(00000431)=0.121392851978464E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 431 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000431)=0.000000000000000E+00 beta (00000432)=0.136968096376012E+02 gamma(00000432)=0.136968096376012E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 432 z1= 1 0.360758890586470E-05 0.000000000000000E+00 z1= 2 0.888083494550480E-03 0.000000000000000E+00 z1= 3 -.305470936965216E-05 0.000000000000000E+00 alpha(00000432)=0.000000000000000E+00 beta (00000433)=0.134464191599758E+02 gamma(00000433)=0.134464191599758E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 433 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000433)=0.000000000000000E+00 beta (00000434)=0.137151590046095E+02 gamma(00000434)=0.137151590046095E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 434 z1= 1 0.324923089337374E-05 0.000000000000000E+00 z1= 2 -.153154751630468E-02 0.000000000000000E+00 z1= 3 -.287545877138053E-05 0.000000000000000E+00 alpha(00000434)=0.000000000000000E+00 beta (00000435)=0.122645796350668E+02 gamma(00000435)=0.122645796350668E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 435 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000435)=0.000000000000000E+00 beta (00000436)=0.134486889669410E+02 gamma(00000436)=0.134486889669410E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 436 z1= 1 0.296286186498738E-05 0.000000000000000E+00 z1= 2 0.189095990579144E-02 0.000000000000000E+00 z1= 3 -.246346059893710E-05 0.000000000000000E+00 alpha(00000436)=0.000000000000000E+00 beta (00000437)=0.122352302453179E+02 gamma(00000437)=0.122352302453179E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 437 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000437)=0.000000000000000E+00 beta (00000438)=0.140834531779250E+02 gamma(00000438)=0.140834531779250E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 438 z1= 1 0.274603582607006E-05 0.000000000000000E+00 z1= 2 -.197000041397962E-02 0.000000000000000E+00 z1= 3 -.248084625611555E-05 0.000000000000000E+00 alpha(00000438)=0.000000000000000E+00 beta (00000439)=0.121594516184956E+02 gamma(00000439)=0.121594516184956E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 439 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000439)=0.000000000000000E+00 beta (00000440)=0.134112979024784E+02 gamma(00000440)=0.134112979024784E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 440 z1= 1 0.282133256975783E-05 0.000000000000000E+00 z1= 2 0.208766428846530E-02 0.000000000000000E+00 z1= 3 -.229269096918517E-05 0.000000000000000E+00 alpha(00000440)=0.000000000000000E+00 beta (00000441)=0.124520933899941E+02 gamma(00000441)=0.124520933899941E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 441 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000441)=0.000000000000000E+00 beta (00000442)=0.131064874514116E+02 gamma(00000442)=0.131064874514116E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 442 z1= 1 0.296542425143667E-05 0.000000000000000E+00 z1= 2 -.223840440811517E-02 0.000000000000000E+00 z1= 3 -.274770070825270E-05 0.000000000000000E+00 alpha(00000442)=0.000000000000000E+00 beta (00000443)=0.132073732463499E+02 gamma(00000443)=0.132073732463499E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 443 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000443)=0.000000000000000E+00 beta (00000444)=0.139867693878152E+02 gamma(00000444)=0.139867693878152E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 444 z1= 1 0.327585202238977E-05 0.000000000000000E+00 z1= 2 0.253719104569096E-02 0.000000000000000E+00 z1= 3 -.264689209181798E-05 0.000000000000000E+00 alpha(00000444)=0.000000000000000E+00 beta (00000445)=0.127805152404128E+02 gamma(00000445)=0.127805152404128E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 445 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000445)=0.000000000000000E+00 beta (00000446)=0.134667337386150E+02 gamma(00000446)=0.134667337386150E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 446 z1= 1 0.260161230058531E-05 0.000000000000000E+00 z1= 2 -.281768201644362E-02 0.000000000000000E+00 z1= 3 -.246292067545965E-05 0.000000000000000E+00 alpha(00000446)=0.000000000000000E+00 beta (00000447)=0.125315979276150E+02 gamma(00000447)=0.125315979276150E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 447 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000447)=0.000000000000000E+00 beta (00000448)=0.132845538299065E+02 gamma(00000448)=0.132845538299065E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 448 z1= 1 0.246463859117580E-05 0.000000000000000E+00 z1= 2 0.274724387448559E-02 0.000000000000000E+00 z1= 3 -.193520460816873E-05 0.000000000000000E+00 alpha(00000448)=0.000000000000000E+00 beta (00000449)=0.129329510709058E+02 gamma(00000449)=0.129329510709058E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 449 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000449)=0.000000000000000E+00 beta (00000450)=0.134674820874034E+02 gamma(00000450)=0.134674820874034E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 450 z1= 1 0.188165440503452E-05 0.000000000000000E+00 z1= 2 -.255329289128334E-02 0.000000000000000E+00 z1= 3 -.185973168284940E-05 0.000000000000000E+00 alpha(00000450)=0.000000000000000E+00 beta (00000451)=0.134102192999098E+02 gamma(00000451)=0.134102192999098E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 451 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000451)=0.000000000000000E+00 beta (00000452)=0.131423239051285E+02 gamma(00000452)=0.131423239051285E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 452 z1= 1 0.148580564365494E-05 0.000000000000000E+00 z1= 2 0.223388306746673E-02 0.000000000000000E+00 z1= 3 -.106834007876973E-05 0.000000000000000E+00 alpha(00000452)=0.000000000000000E+00 beta (00000453)=0.127828797158797E+02 gamma(00000453)=0.127828797158797E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 453 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000453)=0.000000000000000E+00 beta (00000454)=0.136820818880515E+02 gamma(00000454)=0.136820818880515E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 454 z1= 1 0.533869924652323E-06 0.000000000000000E+00 z1= 2 -.139896790940491E-02 0.000000000000000E+00 z1= 3 -.724553407170907E-06 0.000000000000000E+00 alpha(00000454)=0.000000000000000E+00 beta (00000455)=0.124895860260940E+02 gamma(00000455)=0.124895860260940E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 455 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000455)=0.000000000000000E+00 beta (00000456)=0.128255350393116E+02 gamma(00000456)=0.128255350393116E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 456 z1= 1 0.105279901733545E-06 0.000000000000000E+00 z1= 2 0.588526484304338E-03 0.000000000000000E+00 z1= 3 0.116469587984691E-06 0.000000000000000E+00 alpha(00000456)=0.000000000000000E+00 beta (00000457)=0.117666399652755E+02 gamma(00000457)=0.117666399652755E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 457 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000457)=0.000000000000000E+00 beta (00000458)=0.131888903847474E+02 gamma(00000458)=0.131888903847474E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 458 z1= 1 -.908239134799621E-06 0.000000000000000E+00 z1= 2 0.103199926183583E-03 0.000000000000000E+00 z1= 3 0.519666724459319E-06 0.000000000000000E+00 alpha(00000458)=0.000000000000000E+00 beta (00000459)=0.130805865928376E+02 gamma(00000459)=0.130805865928376E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 459 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000459)=0.000000000000000E+00 beta (00000460)=0.132921173105920E+02 gamma(00000460)=0.132921173105920E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 460 z1= 1 -.131895356668757E-05 0.000000000000000E+00 z1= 2 -.577712379323611E-03 0.000000000000000E+00 z1= 3 0.132186504356053E-05 0.000000000000000E+00 alpha(00000460)=0.000000000000000E+00 beta (00000461)=0.130243360186618E+02 gamma(00000461)=0.130243360186618E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 461 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000461)=0.000000000000000E+00 beta (00000462)=0.136849889996631E+02 gamma(00000462)=0.136849889996631E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 462 z1= 1 -.214486226862058E-05 0.000000000000000E+00 z1= 2 0.113614010715124E-02 0.000000000000000E+00 z1= 3 0.155355594258760E-05 0.000000000000000E+00 alpha(00000462)=0.000000000000000E+00 beta (00000463)=0.129187833603126E+02 gamma(00000463)=0.129187833603126E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 463 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000463)=0.000000000000000E+00 beta (00000464)=0.137345422809715E+02 gamma(00000464)=0.137345422809715E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 464 z1= 1 -.209779740977878E-05 0.000000000000000E+00 z1= 2 -.177813624666340E-02 0.000000000000000E+00 z1= 3 0.196921532502159E-05 0.000000000000000E+00 alpha(00000464)=0.000000000000000E+00 beta (00000465)=0.121042179002851E+02 gamma(00000465)=0.121042179002851E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 465 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000465)=0.000000000000000E+00 beta (00000466)=0.134063716487904E+02 gamma(00000466)=0.134063716487904E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 466 z1= 1 -.272822066738282E-05 0.000000000000000E+00 z1= 2 0.221545061056635E-02 0.000000000000000E+00 z1= 3 0.206024478118004E-05 0.000000000000000E+00 alpha(00000466)=0.000000000000000E+00 beta (00000467)=0.131919586231970E+02 gamma(00000467)=0.131919586231970E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 467 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000467)=0.000000000000000E+00 beta (00000468)=0.139410382199768E+02 gamma(00000468)=0.139410382199768E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 468 z1= 1 -.253146993143410E-05 0.000000000000000E+00 z1= 2 -.256073067185854E-02 0.000000000000000E+00 z1= 3 0.232544279968414E-05 0.000000000000000E+00 alpha(00000468)=0.000000000000000E+00 beta (00000469)=0.134801241700618E+02 gamma(00000469)=0.134801241700618E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 469 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000469)=0.000000000000000E+00 beta (00000470)=0.133026132207251E+02 gamma(00000470)=0.133026132207251E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 470 z1= 1 -.202799840099029E-05 0.000000000000000E+00 z1= 2 0.296395205598672E-02 0.000000000000000E+00 z1= 3 0.148359680949076E-05 0.000000000000000E+00 alpha(00000470)=0.000000000000000E+00 beta (00000471)=0.118249538218242E+02 gamma(00000471)=0.118249538218242E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 471 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000471)=0.000000000000000E+00 beta (00000472)=0.133713112754944E+02 gamma(00000472)=0.133713112754944E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 472 z1= 1 -.123677317438774E-05 0.000000000000000E+00 z1= 2 -.271794416060606E-02 0.000000000000000E+00 z1= 3 0.122179900316250E-05 0.000000000000000E+00 alpha(00000472)=0.000000000000000E+00 beta (00000473)=0.128965044835965E+02 gamma(00000473)=0.128965044835965E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 473 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000473)=0.000000000000000E+00 beta (00000474)=0.135765472016499E+02 gamma(00000474)=0.135765472016499E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 474 z1= 1 -.101869386698707E-05 0.000000000000000E+00 z1= 2 0.267600959605814E-02 0.000000000000000E+00 z1= 3 0.683321350970160E-06 0.000000000000000E+00 alpha(00000474)=0.000000000000000E+00 beta (00000475)=0.127743766683950E+02 gamma(00000475)=0.127743766683950E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 475 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000475)=0.000000000000000E+00 beta (00000476)=0.127662425162187E+02 gamma(00000476)=0.127662425162187E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 476 z1= 1 -.288280488756551E-06 0.000000000000000E+00 z1= 2 -.293390827039673E-02 0.000000000000000E+00 z1= 3 0.413567770616652E-06 0.000000000000000E+00 alpha(00000476)=0.000000000000000E+00 beta (00000477)=0.125325003078792E+02 gamma(00000477)=0.125325003078792E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 477 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000477)=0.000000000000000E+00 beta (00000478)=0.137442806096113E+02 gamma(00000478)=0.137442806096113E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 478 z1= 1 -.965536911937993E-07 0.000000000000000E+00 z1= 2 0.287068607462397E-02 0.000000000000000E+00 z1= 3 -.752233983542742E-07 0.000000000000000E+00 alpha(00000478)=0.000000000000000E+00 beta (00000479)=0.120028151332376E+02 gamma(00000479)=0.120028151332376E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 479 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000479)=0.000000000000000E+00 beta (00000480)=0.124406518122629E+02 gamma(00000480)=0.124406518122629E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 480 z1= 1 0.591662534177133E-06 0.000000000000000E+00 z1= 2 -.308634625517459E-02 0.000000000000000E+00 z1= 3 -.351246531064223E-06 0.000000000000000E+00 alpha(00000480)=0.000000000000000E+00 beta (00000481)=0.125414499387983E+02 gamma(00000481)=0.125414499387983E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 481 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000481)=0.000000000000000E+00 beta (00000482)=0.137298273439261E+02 gamma(00000482)=0.137298273439261E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 482 z1= 1 0.973202366771377E-06 0.000000000000000E+00 z1= 2 0.309644969242228E-02 0.000000000000000E+00 z1= 3 -.921348805275760E-06 0.000000000000000E+00 alpha(00000482)=0.000000000000000E+00 beta (00000483)=0.124380833518010E+02 gamma(00000483)=0.124380833518010E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 483 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000483)=0.000000000000000E+00 beta (00000484)=0.136564288826589E+02 gamma(00000484)=0.136564288826589E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 484 z1= 1 0.169723518907497E-05 0.000000000000000E+00 z1= 2 -.301164946448779E-02 0.000000000000000E+00 z1= 3 -.130355132206225E-05 0.000000000000000E+00 alpha(00000484)=0.000000000000000E+00 beta (00000485)=0.122595671969459E+02 gamma(00000485)=0.122595671969459E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 485 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000485)=0.000000000000000E+00 beta (00000486)=0.132892909586629E+02 gamma(00000486)=0.132892909586629E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 486 z1= 1 0.226799025989950E-05 0.000000000000000E+00 z1= 2 0.302807780714378E-02 0.000000000000000E+00 z1= 3 -.198910101884063E-05 0.000000000000000E+00 alpha(00000486)=0.000000000000000E+00 beta (00000487)=0.125690812682631E+02 gamma(00000487)=0.125690812682631E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 487 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000487)=0.000000000000000E+00 beta (00000488)=0.138797280457322E+02 gamma(00000488)=0.138797280457322E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 488 z1= 1 0.323685469906347E-05 0.000000000000000E+00 z1= 2 -.323393549613714E-02 0.000000000000000E+00 z1= 3 -.261382965201207E-05 0.000000000000000E+00 alpha(00000488)=0.000000000000000E+00 beta (00000489)=0.124481624355550E+02 gamma(00000489)=0.124481624355550E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 489 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000489)=0.000000000000000E+00 beta (00000490)=0.133787261548690E+02 gamma(00000490)=0.133787261548690E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 490 z1= 1 0.389122996562966E-05 0.000000000000000E+00 z1= 2 0.367961426886604E-02 0.000000000000000E+00 z1= 3 -.331382115648592E-05 0.000000000000000E+00 alpha(00000490)=0.000000000000000E+00 beta (00000491)=0.132987890157629E+02 gamma(00000491)=0.132987890157629E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 491 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000491)=0.000000000000000E+00 beta (00000492)=0.128311875586876E+02 gamma(00000492)=0.128311875586876E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 492 z1= 1 0.454965338633675E-05 0.000000000000000E+00 z1= 2 -.470994871365604E-02 0.000000000000000E+00 z1= 3 -.371035337256784E-05 0.000000000000000E+00 alpha(00000492)=0.000000000000000E+00 beta (00000493)=0.122410683276169E+02 gamma(00000493)=0.122410683276169E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 493 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000493)=0.000000000000000E+00 beta (00000494)=0.132529227492193E+02 gamma(00000494)=0.132529227492193E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 494 z1= 1 0.599113050562920E-05 0.000000000000000E+00 z1= 2 0.524003717279033E-02 0.000000000000000E+00 z1= 3 -.506172546547502E-05 0.000000000000000E+00 alpha(00000494)=0.000000000000000E+00 beta (00000495)=0.126136758698444E+02 gamma(00000495)=0.126136758698444E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 495 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000495)=0.000000000000000E+00 beta (00000496)=0.138891090737274E+02 gamma(00000496)=0.138891090737274E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 496 z1= 1 0.794298169839438E-05 0.000000000000000E+00 z1= 2 -.560014092429287E-02 0.000000000000000E+00 z1= 3 -.655573794087583E-05 0.000000000000000E+00 alpha(00000496)=0.000000000000000E+00 beta (00000497)=0.127195680202821E+02 gamma(00000497)=0.127195680202821E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 497 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000497)=0.000000000000000E+00 beta (00000498)=0.130460914938698E+02 gamma(00000498)=0.130460914938698E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 498 z1= 1 0.918914755933730E-05 0.000000000000000E+00 z1= 2 0.637058697887520E-02 0.000000000000000E+00 z1= 3 -.772247585551899E-05 0.000000000000000E+00 alpha(00000498)=0.000000000000000E+00 beta (00000499)=0.126154350648866E+02 gamma(00000499)=0.126154350648866E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 499 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000499)=0.000000000000000E+00 beta (00000500)=0.131071543003682E+02 gamma(00000500)=0.131071543003682E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 500 z1= 1 0.119347790121954E-04 0.000000000000000E+00 z1= 2 -.700152216809832E-02 0.000000000000000E+00 z1= 3 -.988823029269593E-05 0.000000000000000E+00 alpha(00000500)=0.000000000000000E+00 beta (00000501)=0.128009893284456E+02 gamma(00000501)=0.128009893284456E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Norm of initial Lanczos vectors= 1.469000513771654 Starting Lanczos loop 3 Lanczos iteration: 1 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal alpha(00000001)=0.000000000000000E+00 beta (00000002)=0.183408489342923E+01 gamma(00000002)=0.183408489342923E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 2 z1= 1 -.557750295633336E-06 0.000000000000000E+00 z1= 2 -.431771645483577E-06 0.000000000000000E+00 z1= 3 0.990801583330463E+00 0.000000000000000E+00 alpha(00000002)=0.000000000000000E+00 beta (00000003)=0.572337571392305E+01 gamma(00000003)=0.572337571392305E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 3 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000003)=0.000000000000000E+00 beta (00000004)=0.138861120426111E+02 gamma(00000004)=0.138861120426111E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 4 z1= 1 0.208999462908074E-06 0.000000000000000E+00 z1= 2 0.160896552455457E-06 0.000000000000000E+00 z1= 3 -.330755238884875E+00 0.000000000000000E+00 alpha(00000004)=0.000000000000000E+00 beta (00000005)=0.123143164386044E+02 gamma(00000005)=0.123143164386044E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 5 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000005)=0.000000000000000E+00 beta (00000006)=0.137542227844173E+02 gamma(00000006)=0.137542227844173E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 6 z1= 1 -.190040362225887E-06 0.000000000000000E+00 z1= 2 -.145323266200923E-06 0.000000000000000E+00 z1= 3 0.266479295589780E+00 0.000000000000000E+00 alpha(00000006)=0.000000000000000E+00 beta (00000007)=0.126558002489348E+02 gamma(00000007)=0.126558002489348E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 7 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000007)=0.000000000000000E+00 beta (00000008)=0.134527256331163E+02 gamma(00000008)=0.134527256331163E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 8 z1= 1 0.196864499743326E-06 0.000000000000000E+00 z1= 2 0.151028615798200E-06 0.000000000000000E+00 z1= 3 -.233104090628810E+00 0.000000000000000E+00 alpha(00000008)=0.000000000000000E+00 beta (00000009)=0.127405132127960E+02 gamma(00000009)=0.127405132127960E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 9 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000009)=0.000000000000000E+00 beta (00000010)=0.134621138850558E+02 gamma(00000010)=0.134621138850558E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 10 z1= 1 -.210041549832856E-06 0.000000000000000E+00 z1= 2 -.161574305311031E-06 0.000000000000000E+00 z1= 3 0.208828305114071E+00 0.000000000000000E+00 alpha(00000010)=0.000000000000000E+00 beta (00000011)=0.127778326041975E+02 gamma(00000011)=0.127778326041975E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 11 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000011)=0.000000000000000E+00 beta (00000012)=0.135178857771737E+02 gamma(00000012)=0.135178857771737E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 12 z1= 1 0.215904815323818E-06 0.000000000000000E+00 z1= 2 0.165410579074316E-06 0.000000000000000E+00 z1= 3 -.188479901110311E+00 0.000000000000000E+00 alpha(00000012)=0.000000000000000E+00 beta (00000013)=0.127513453731436E+02 gamma(00000013)=0.127513453731436E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 13 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000013)=0.000000000000000E+00 beta (00000014)=0.134908015016944E+02 gamma(00000014)=0.134908015016944E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 14 z1= 1 -.211099852473039E-06 0.000000000000000E+00 z1= 2 -.160287778077110E-06 0.000000000000000E+00 z1= 3 0.170998820422313E+00 0.000000000000000E+00 alpha(00000014)=0.000000000000000E+00 beta (00000015)=0.127936780206129E+02 gamma(00000015)=0.127936780206129E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 15 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000015)=0.000000000000000E+00 beta (00000016)=0.135567098379334E+02 gamma(00000016)=0.135567098379334E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 16 z1= 1 0.198955815433177E-06 0.000000000000000E+00 z1= 2 0.149125137224437E-06 0.000000000000000E+00 z1= 3 -.155434428079156E+00 0.000000000000000E+00 alpha(00000016)=0.000000000000000E+00 beta (00000017)=0.127918128900340E+02 gamma(00000017)=0.127918128900340E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 17 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000017)=0.000000000000000E+00 beta (00000018)=0.133937082486551E+02 gamma(00000018)=0.133937082486551E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 18 z1= 1 -.182015526639916E-06 0.000000000000000E+00 z1= 2 -.134225769739867E-06 0.000000000000000E+00 z1= 3 0.143390544367308E+00 0.000000000000000E+00 alpha(00000018)=0.000000000000000E+00 beta (00000019)=0.126916720277325E+02 gamma(00000019)=0.126916720277325E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 19 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000019)=0.000000000000000E+00 beta (00000020)=0.133733644616341E+02 gamma(00000020)=0.133733644616341E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 20 z1= 1 0.161748315592476E-06 0.000000000000000E+00 z1= 2 0.116768777559282E-06 0.000000000000000E+00 z1= 3 -.131850265545468E+00 0.000000000000000E+00 alpha(00000020)=0.000000000000000E+00 beta (00000021)=0.127260413893724E+02 gamma(00000021)=0.127260413893724E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 21 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000021)=0.000000000000000E+00 beta (00000022)=0.134820103430842E+02 gamma(00000022)=0.134820103430842E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 22 z1= 1 -.142138920251455E-06 0.000000000000000E+00 z1= 2 -.999243202925472E-07 0.000000000000000E+00 z1= 3 0.120961195232874E+00 0.000000000000000E+00 alpha(00000022)=0.000000000000000E+00 beta (00000023)=0.129128494121748E+02 gamma(00000023)=0.129128494121748E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 23 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000023)=0.000000000000000E+00 beta (00000024)=0.132837305591500E+02 gamma(00000024)=0.132837305591500E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 24 z1= 1 0.130306813290581E-06 0.000000000000000E+00 z1= 2 0.887713264992838E-07 0.000000000000000E+00 z1= 3 -.114671738986539E+00 0.000000000000000E+00 alpha(00000024)=0.000000000000000E+00 beta (00000025)=0.125388176227828E+02 gamma(00000025)=0.125388176227828E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 25 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000025)=0.000000000000000E+00 beta (00000026)=0.135589538060908E+02 gamma(00000026)=0.135589538060908E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 26 z1= 1 -.113828186749151E-06 0.000000000000000E+00 z1= 2 -.746388215781824E-07 0.000000000000000E+00 z1= 3 0.103641742329266E+00 0.000000000000000E+00 alpha(00000026)=0.000000000000000E+00 beta (00000027)=0.129337647735108E+02 gamma(00000027)=0.129337647735108E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 27 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000027)=0.000000000000000E+00 beta (00000028)=0.133335184093775E+02 gamma(00000028)=0.133335184093775E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 28 z1= 1 0.107438525151146E-06 0.000000000000000E+00 z1= 2 0.678166944007713E-07 0.000000000000000E+00 z1= 3 -.985034149120091E-01 0.000000000000000E+00 alpha(00000028)=0.000000000000000E+00 beta (00000029)=0.128951590216963E+02 gamma(00000029)=0.128951590216963E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 29 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000029)=0.000000000000000E+00 beta (00000030)=0.135410732228374E+02 gamma(00000030)=0.135410732228374E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 30 z1= 1 -.986528611371384E-07 0.000000000000000E+00 z1= 2 -.596136450225528E-07 0.000000000000000E+00 z1= 3 0.920547910258209E-01 0.000000000000000E+00 alpha(00000030)=0.000000000000000E+00 beta (00000031)=0.127912919249742E+02 gamma(00000031)=0.127912919249742E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 31 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000031)=0.000000000000000E+00 beta (00000032)=0.133985346181592E+02 gamma(00000032)=0.133985346181592E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 32 z1= 1 0.857259188536026E-07 0.000000000000000E+00 z1= 2 0.484025719565614E-07 0.000000000000000E+00 z1= 3 -.864160465963053E-01 0.000000000000000E+00 alpha(00000032)=0.000000000000000E+00 beta (00000033)=0.127353149892954E+02 gamma(00000033)=0.127353149892954E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 33 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000033)=0.000000000000000E+00 beta (00000034)=0.135903245861276E+02 gamma(00000034)=0.135903245861276E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 34 z1= 1 -.693626166941609E-07 0.000000000000000E+00 z1= 2 -.348704387136134E-07 0.000000000000000E+00 z1= 3 0.797403250291881E-01 0.000000000000000E+00 alpha(00000034)=0.000000000000000E+00 beta (00000035)=0.125676813189083E+02 gamma(00000035)=0.125676813189083E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 35 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000035)=0.000000000000000E+00 beta (00000036)=0.131270519069805E+02 gamma(00000036)=0.131270519069805E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 36 z1= 1 0.482837741087004E-07 0.000000000000000E+00 z1= 2 0.172319716347687E-07 0.000000000000000E+00 z1= 3 -.750281374001054E-01 0.000000000000000E+00 alpha(00000036)=0.000000000000000E+00 beta (00000037)=0.128541684831171E+02 gamma(00000037)=0.128541684831171E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 37 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000037)=0.000000000000000E+00 beta (00000038)=0.133559039933408E+02 gamma(00000038)=0.133559039933408E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 38 z1= 1 -.235951433209466E-07 0.000000000000000E+00 z1= 2 0.324394758147509E-08 0.000000000000000E+00 z1= 3 0.711338121716460E-01 0.000000000000000E+00 alpha(00000038)=0.000000000000000E+00 beta (00000039)=0.128572415286697E+02 gamma(00000039)=0.128572415286697E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 39 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000039)=0.000000000000000E+00 beta (00000040)=0.131516067445573E+02 gamma(00000040)=0.131516067445573E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 40 z1= 1 -.716733257379726E-08 0.000000000000000E+00 z1= 2 -.288980508398630E-07 0.000000000000000E+00 z1= 3 -.685794423244947E-01 0.000000000000000E+00 alpha(00000040)=0.000000000000000E+00 beta (00000041)=0.127262520985739E+02 gamma(00000041)=0.127262520985739E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 41 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000041)=0.000000000000000E+00 beta (00000042)=0.135352418292516E+02 gamma(00000042)=0.135352418292516E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 42 z1= 1 0.393383339392789E-07 0.000000000000000E+00 z1= 2 0.547399067805758E-07 0.000000000000000E+00 z1= 3 0.635428406445662E-01 0.000000000000000E+00 alpha(00000042)=0.000000000000000E+00 beta (00000043)=0.127360201394324E+02 gamma(00000043)=0.127360201394324E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 43 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000043)=0.000000000000000E+00 beta (00000044)=0.133909957915695E+02 gamma(00000044)=0.133909957915695E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 44 z1= 1 -.655559069320799E-07 0.000000000000000E+00 z1= 2 -.763574470579592E-07 0.000000000000000E+00 z1= 3 -.595802806805402E-01 0.000000000000000E+00 alpha(00000044)=0.000000000000000E+00 beta (00000045)=0.124244390628203E+02 gamma(00000045)=0.124244390628203E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 45 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000045)=0.000000000000000E+00 beta (00000046)=0.132663030925292E+02 gamma(00000046)=0.132663030925292E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 46 z1= 1 0.876930383135466E-07 0.000000000000000E+00 z1= 2 0.946750551710125E-07 0.000000000000000E+00 z1= 3 0.549391028110763E-01 0.000000000000000E+00 alpha(00000046)=0.000000000000000E+00 beta (00000047)=0.123512733822518E+02 gamma(00000047)=0.123512733822518E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 47 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000047)=0.000000000000000E+00 beta (00000048)=0.133710000099177E+02 gamma(00000048)=0.133710000099177E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 48 z1= 1 -.107530766940873E-06 0.000000000000000E+00 z1= 2 -.111303630746535E-06 0.000000000000000E+00 z1= 3 -.497885028856581E-01 0.000000000000000E+00 alpha(00000048)=0.000000000000000E+00 beta (00000049)=0.131080323792331E+02 gamma(00000049)=0.131080323792331E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 49 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000049)=0.000000000000000E+00 beta (00000050)=0.136794186632358E+02 gamma(00000050)=0.136794186632358E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 50 z1= 1 0.123600980218158E-06 0.000000000000000E+00 z1= 2 0.125712369255723E-06 0.000000000000000E+00 z1= 3 0.469846659564791E-01 0.000000000000000E+00 alpha(00000050)=0.000000000000000E+00 beta (00000051)=0.126058122373934E+02 gamma(00000051)=0.126058122373934E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 51 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000051)=0.000000000000000E+00 beta (00000052)=0.133780909700422E+02 gamma(00000052)=0.133780909700422E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 52 z1= 1 -.132728306978872E-06 0.000000000000000E+00 z1= 2 -.134370805395228E-06 0.000000000000000E+00 z1= 3 -.435538337816693E-01 0.000000000000000E+00 alpha(00000052)=0.000000000000000E+00 beta (00000053)=0.126303848132607E+02 gamma(00000053)=0.126303848132607E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 53 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000053)=0.000000000000000E+00 beta (00000054)=0.130423027576230E+02 gamma(00000054)=0.130423027576230E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 54 z1= 1 0.139189254844997E-06 0.000000000000000E+00 z1= 2 0.142057012357359E-06 0.000000000000000E+00 z1= 3 0.415352471119155E-01 0.000000000000000E+00 alpha(00000054)=0.000000000000000E+00 beta (00000055)=0.132443023385148E+02 gamma(00000055)=0.132443023385148E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 55 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000055)=0.000000000000000E+00 beta (00000056)=0.133031869438967E+02 gamma(00000056)=0.133031869438967E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 56 z1= 1 -.141764816849986E-06 0.000000000000000E+00 z1= 2 -.147105153922716E-06 0.000000000000000E+00 z1= 3 -.408111435333645E-01 0.000000000000000E+00 alpha(00000056)=0.000000000000000E+00 beta (00000057)=0.130912325222134E+02 gamma(00000057)=0.130912325222134E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 57 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000057)=0.000000000000000E+00 beta (00000058)=0.131870325232421E+02 gamma(00000058)=0.131870325232421E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 58 z1= 1 0.144803859994727E-06 0.000000000000000E+00 z1= 2 0.152229581326397E-06 0.000000000000000E+00 z1= 3 0.399652134664024E-01 0.000000000000000E+00 alpha(00000058)=0.000000000000000E+00 beta (00000059)=0.128670303351552E+02 gamma(00000059)=0.128670303351552E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 59 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000059)=0.000000000000000E+00 beta (00000060)=0.134508631548421E+02 gamma(00000060)=0.134508631548421E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 60 z1= 1 -.143212621076319E-06 0.000000000000000E+00 z1= 2 -.152216956842907E-06 0.000000000000000E+00 z1= 3 -.377198973347552E-01 0.000000000000000E+00 alpha(00000060)=0.000000000000000E+00 beta (00000061)=0.130151318259181E+02 gamma(00000061)=0.130151318259181E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 61 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000061)=0.000000000000000E+00 beta (00000062)=0.137093709325519E+02 gamma(00000062)=0.137093709325519E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 62 z1= 1 0.140127760834934E-06 0.000000000000000E+00 z1= 2 0.150503621998681E-06 0.000000000000000E+00 z1= 3 0.352298430068879E-01 0.000000000000000E+00 alpha(00000062)=0.000000000000000E+00 beta (00000063)=0.129991551124204E+02 gamma(00000063)=0.129991551124204E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 63 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000063)=0.000000000000000E+00 beta (00000064)=0.132904725079998E+02 gamma(00000064)=0.132904725079998E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 64 z1= 1 -.144997117206176E-06 0.000000000000000E+00 z1= 2 -.156085177507696E-06 0.000000000000000E+00 z1= 3 -.339058123310926E-01 0.000000000000000E+00 alpha(00000064)=0.000000000000000E+00 beta (00000065)=0.124219740373089E+02 gamma(00000065)=0.124219740373089E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 65 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000065)=0.000000000000000E+00 beta (00000066)=0.132809548310398E+02 gamma(00000066)=0.132809548310398E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 66 z1= 1 0.148232962310195E-06 0.000000000000000E+00 z1= 2 0.158497835983477E-06 0.000000000000000E+00 z1= 3 0.312993107904411E-01 0.000000000000000E+00 alpha(00000066)=0.000000000000000E+00 beta (00000067)=0.131508961130707E+02 gamma(00000067)=0.131508961130707E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 67 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000067)=0.000000000000000E+00 beta (00000068)=0.137579519140182E+02 gamma(00000068)=0.137579519140182E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 68 z1= 1 -.154827149439693E-06 0.000000000000000E+00 z1= 2 -.164240256796643E-06 0.000000000000000E+00 z1= 3 -.296505189336487E-01 0.000000000000000E+00 alpha(00000068)=0.000000000000000E+00 beta (00000069)=0.129305389144244E+02 gamma(00000069)=0.129305389144244E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 69 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000069)=0.000000000000000E+00 beta (00000070)=0.131645985276493E+02 gamma(00000070)=0.131645985276493E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 70 z1= 1 0.165076669706929E-06 0.000000000000000E+00 z1= 2 0.174144866972939E-06 0.000000000000000E+00 z1= 3 0.288886238767751E-01 0.000000000000000E+00 alpha(00000070)=0.000000000000000E+00 beta (00000071)=0.126044506393183E+02 gamma(00000071)=0.126044506393183E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 71 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000071)=0.000000000000000E+00 beta (00000072)=0.136173440652292E+02 gamma(00000072)=0.136173440652292E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 72 z1= 1 -.170404625386006E-06 0.000000000000000E+00 z1= 2 -.177767824276025E-06 0.000000000000000E+00 z1= 3 -.265937575267403E-01 0.000000000000000E+00 alpha(00000072)=0.000000000000000E+00 beta (00000073)=0.127244323824127E+02 gamma(00000073)=0.127244323824127E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 73 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000073)=0.000000000000000E+00 beta (00000074)=0.131219639212889E+02 gamma(00000074)=0.131219639212889E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 74 z1= 1 0.187402637101194E-06 0.000000000000000E+00 z1= 2 0.192754149634655E-06 0.000000000000000E+00 z1= 3 0.255974774886964E-01 0.000000000000000E+00 alpha(00000074)=0.000000000000000E+00 beta (00000075)=0.124271684505809E+02 gamma(00000075)=0.124271684505809E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 75 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000075)=0.000000000000000E+00 beta (00000076)=0.133410221875789E+02 gamma(00000076)=0.133410221875789E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 76 z1= 1 -.194008204126850E-06 0.000000000000000E+00 z1= 2 -.197412174446007E-06 0.000000000000000E+00 z1= 3 -.236182595255203E-01 0.000000000000000E+00 alpha(00000076)=0.000000000000000E+00 beta (00000077)=0.127582465557313E+02 gamma(00000077)=0.127582465557313E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 77 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000077)=0.000000000000000E+00 beta (00000078)=0.137338063578882E+02 gamma(00000078)=0.137338063578882E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 78 z1= 1 0.200509399941179E-06 0.000000000000000E+00 z1= 2 0.201811560640759E-06 0.000000000000000E+00 z1= 3 0.219149235164585E-01 0.000000000000000E+00 alpha(00000078)=0.000000000000000E+00 beta (00000079)=0.125533716242748E+02 gamma(00000079)=0.125533716242748E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 79 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000079)=0.000000000000000E+00 beta (00000080)=0.132067529469689E+02 gamma(00000080)=0.132067529469689E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 80 z1= 1 -.209787321137252E-06 0.000000000000000E+00 z1= 2 -.209974852666620E-06 0.000000000000000E+00 z1= 3 -.209236731784242E-01 0.000000000000000E+00 alpha(00000080)=0.000000000000000E+00 beta (00000081)=0.127296772324676E+02 gamma(00000081)=0.127296772324676E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 81 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000081)=0.000000000000000E+00 beta (00000082)=0.138731636113619E+02 gamma(00000082)=0.138731636113619E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 82 z1= 1 0.208320225439720E-06 0.000000000000000E+00 z1= 2 0.208079203515080E-06 0.000000000000000E+00 z1= 3 0.193308510958476E-01 0.000000000000000E+00 alpha(00000082)=0.000000000000000E+00 beta (00000083)=0.126812281263001E+02 gamma(00000083)=0.126812281263001E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 83 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000083)=0.000000000000000E+00 beta (00000084)=0.130964111966943E+02 gamma(00000084)=0.130964111966943E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 84 z1= 1 -.220498013174530E-06 0.000000000000000E+00 z1= 2 -.219670998678582E-06 0.000000000000000E+00 z1= 3 -.188109662662665E-01 0.000000000000000E+00 alpha(00000084)=0.000000000000000E+00 beta (00000085)=0.126005773345656E+02 gamma(00000085)=0.126005773345656E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 85 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000085)=0.000000000000000E+00 beta (00000086)=0.139568608050759E+02 gamma(00000086)=0.139568608050759E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 86 z1= 1 0.217086153475252E-06 0.000000000000000E+00 z1= 2 0.215408813130508E-06 0.000000000000000E+00 z1= 3 0.169458603306586E-01 0.000000000000000E+00 alpha(00000086)=0.000000000000000E+00 beta (00000087)=0.125283232663942E+02 gamma(00000087)=0.125283232663942E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 87 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000087)=0.000000000000000E+00 beta (00000088)=0.130426648304064E+02 gamma(00000088)=0.130426648304064E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 88 z1= 1 -.222044791245608E-06 0.000000000000000E+00 z1= 2 -.220398792629556E-06 0.000000000000000E+00 z1= 3 -.160286916700357E-01 0.000000000000000E+00 alpha(00000088)=0.000000000000000E+00 beta (00000089)=0.129410182025023E+02 gamma(00000089)=0.129410182025023E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 89 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000089)=0.000000000000000E+00 beta (00000090)=0.135148921065201E+02 gamma(00000090)=0.135148921065201E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 90 z1= 1 0.217975614284077E-06 0.000000000000000E+00 z1= 2 0.218388176569627E-06 0.000000000000000E+00 z1= 3 0.149680051816872E-01 0.000000000000000E+00 alpha(00000090)=0.000000000000000E+00 beta (00000091)=0.124482052171673E+02 gamma(00000091)=0.124482052171673E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 91 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000091)=0.000000000000000E+00 beta (00000092)=0.130591003934664E+02 gamma(00000092)=0.130591003934664E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 92 z1= 1 -.214399437778977E-06 0.000000000000000E+00 z1= 2 -.217260240425836E-06 0.000000000000000E+00 z1= 3 -.138409521545317E-01 0.000000000000000E+00 alpha(00000092)=0.000000000000000E+00 beta (00000093)=0.130360461433480E+02 gamma(00000093)=0.130360461433480E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 93 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000093)=0.000000000000000E+00 beta (00000094)=0.129280171391123E+02 gamma(00000094)=0.129280171391123E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 94 z1= 1 0.218097257363367E-06 0.000000000000000E+00 z1= 2 0.224271727464372E-06 0.000000000000000E+00 z1= 3 0.135223643843884E-01 0.000000000000000E+00 alpha(00000094)=0.000000000000000E+00 beta (00000095)=0.122336918130046E+02 gamma(00000095)=0.122336918130046E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 95 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000095)=0.000000000000000E+00 beta (00000096)=0.128080683650938E+02 gamma(00000096)=0.128080683650938E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 96 z1= 1 -.207760548785740E-06 0.000000000000000E+00 z1= 2 -.217546701606133E-06 0.000000000000000E+00 z1= 3 -.125727307456646E-01 0.000000000000000E+00 alpha(00000096)=0.000000000000000E+00 beta (00000097)=0.127706175507601E+02 gamma(00000097)=0.127706175507601E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 97 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000097)=0.000000000000000E+00 beta (00000098)=0.126718464959042E+02 gamma(00000098)=0.126718464959042E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 98 z1= 1 0.211583742932425E-06 0.000000000000000E+00 z1= 2 0.224778973583611E-06 0.000000000000000E+00 z1= 3 0.122626105789944E-01 0.000000000000000E+00 alpha(00000098)=0.000000000000000E+00 beta (00000099)=0.122002917251760E+02 gamma(00000099)=0.122002917251760E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 99 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000099)=0.000000000000000E+00 beta (00000100)=0.134328820732773E+02 gamma(00000100)=0.134328820732773E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 100 z1= 1 -.186615252029121E-06 0.000000000000000E+00 z1= 2 -.203815579406796E-06 0.000000000000000E+00 z1= 3 -.107982806576514E-01 0.000000000000000E+00 alpha(00000100)=0.000000000000000E+00 beta (00000101)=0.129919939959400E+02 gamma(00000101)=0.129919939959400E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 101 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000101)=0.000000000000000E+00 beta (00000102)=0.132098940535969E+02 gamma(00000102)=0.132098940535969E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 102 z1= 1 0.174251938841671E-06 0.000000000000000E+00 z1= 2 0.197006234528910E-06 0.000000000000000E+00 z1= 3 0.104500637444396E-01 0.000000000000000E+00 alpha(00000102)=0.000000000000000E+00 beta (00000103)=0.133614113472530E+02 gamma(00000103)=0.133614113472530E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 103 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000103)=0.000000000000000E+00 beta (00000104)=0.128938385884394E+02 gamma(00000104)=0.128938385884394E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 104 z1= 1 -.177841323041258E-06 0.000000000000000E+00 z1= 2 -.205578979444766E-06 0.000000000000000E+00 z1= 3 -.110563902434846E-01 0.000000000000000E+00 alpha(00000104)=0.000000000000000E+00 beta (00000105)=0.132018187721825E+02 gamma(00000105)=0.132018187721825E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 105 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000105)=0.000000000000000E+00 beta (00000106)=0.137901560653045E+02 gamma(00000106)=0.137901560653045E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 106 z1= 1 0.168794461104585E-06 0.000000000000000E+00 z1= 2 0.199124644054832E-06 0.000000000000000E+00 z1= 3 0.109269257665198E-01 0.000000000000000E+00 alpha(00000106)=0.000000000000000E+00 beta (00000107)=0.131785114418289E+02 gamma(00000107)=0.131785114418289E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 107 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000107)=0.000000000000000E+00 beta (00000108)=0.132913088518028E+02 gamma(00000108)=0.132913088518028E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 108 z1= 1 -.166307142815750E-06 0.000000000000000E+00 z1= 2 -.200561516670514E-06 0.000000000000000E+00 z1= 3 -.111478138824687E-01 0.000000000000000E+00 alpha(00000108)=0.000000000000000E+00 beta (00000109)=0.131813985809254E+02 gamma(00000109)=0.131813985809254E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 109 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000109)=0.000000000000000E+00 beta (00000110)=0.128018458783791E+02 gamma(00000110)=0.128018458783791E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 110 z1= 1 0.167690748814620E-06 0.000000000000000E+00 z1= 2 0.207316527290821E-06 0.000000000000000E+00 z1= 3 0.117677630612309E-01 0.000000000000000E+00 alpha(00000110)=0.000000000000000E+00 beta (00000111)=0.130264152503754E+02 gamma(00000111)=0.130264152503754E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 111 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000111)=0.000000000000000E+00 beta (00000112)=0.134223603902258E+02 gamma(00000112)=0.134223603902258E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 112 z1= 1 -.149833860046619E-06 0.000000000000000E+00 z1= 2 -.193774197544509E-06 0.000000000000000E+00 z1= 3 -.115151978035835E-01 0.000000000000000E+00 alpha(00000112)=0.000000000000000E+00 beta (00000113)=0.126782686413062E+02 gamma(00000113)=0.126782686413062E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 113 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000113)=0.000000000000000E+00 beta (00000114)=0.131589975980825E+02 gamma(00000114)=0.131589975980825E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 114 z1= 1 0.131560117013971E-06 0.000000000000000E+00 z1= 2 0.179451395717137E-06 0.000000000000000E+00 z1= 3 0.111951331811843E-01 0.000000000000000E+00 alpha(00000114)=0.000000000000000E+00 beta (00000115)=0.124669195505391E+02 gamma(00000115)=0.124669195505391E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 115 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000115)=0.000000000000000E+00 beta (00000116)=0.134367299041259E+02 gamma(00000116)=0.134367299041259E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 116 z1= 1 -.117049303203012E-06 0.000000000000000E+00 z1= 2 -.165282646664641E-06 0.000000000000000E+00 z1= 3 -.107811566036919E-01 0.000000000000000E+00 alpha(00000116)=0.000000000000000E+00 beta (00000117)=0.123608413884213E+02 gamma(00000117)=0.123608413884213E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 117 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000117)=0.000000000000000E+00 beta (00000118)=0.132506547531944E+02 gamma(00000118)=0.132506547531944E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 118 z1= 1 0.105226232552033E-06 0.000000000000000E+00 z1= 2 0.154195193047962E-06 0.000000000000000E+00 z1= 3 0.103649777429311E-01 0.000000000000000E+00 alpha(00000118)=0.000000000000000E+00 beta (00000119)=0.127796538359744E+02 gamma(00000119)=0.127796538359744E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 119 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000119)=0.000000000000000E+00 beta (00000120)=0.132042573737029E+02 gamma(00000120)=0.132042573737029E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 120 z1= 1 -.901260816671412E-07 0.000000000000000E+00 z1= 2 -.143218402816857E-06 0.000000000000000E+00 z1= 3 -.100927479146356E-01 0.000000000000000E+00 alpha(00000120)=0.000000000000000E+00 beta (00000121)=0.123933049034350E+02 gamma(00000121)=0.123933049034350E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 121 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000121)=0.000000000000000E+00 beta (00000122)=0.129982077362073E+02 gamma(00000122)=0.129982077362073E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 122 z1= 1 0.740570210329417E-07 0.000000000000000E+00 z1= 2 0.130032787416974E-06 0.000000000000000E+00 z1= 3 0.968947822913532E-02 0.000000000000000E+00 alpha(00000122)=0.000000000000000E+00 beta (00000123)=0.128338253086397E+02 gamma(00000123)=0.128338253086397E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 123 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000123)=0.000000000000000E+00 beta (00000124)=0.135790436720755E+02 gamma(00000124)=0.135790436720755E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 124 z1= 1 -.557564949436179E-07 0.000000000000000E+00 z1= 2 -.114324130317048E-06 0.000000000000000E+00 z1= 3 -.907008614438760E-02 0.000000000000000E+00 alpha(00000124)=0.000000000000000E+00 beta (00000125)=0.128904241454039E+02 gamma(00000125)=0.128904241454039E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 125 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000125)=0.000000000000000E+00 beta (00000126)=0.135564019731053E+02 gamma(00000126)=0.135564019731053E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 126 z1= 1 0.480969535067433E-07 0.000000000000000E+00 z1= 2 0.107449062870281E-06 0.000000000000000E+00 z1= 3 0.862235770928489E-02 0.000000000000000E+00 alpha(00000126)=0.000000000000000E+00 beta (00000127)=0.127971578038256E+02 gamma(00000127)=0.127971578038256E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 127 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000127)=0.000000000000000E+00 beta (00000128)=0.136536953420108E+02 gamma(00000128)=0.136536953420108E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 128 z1= 1 -.496151145931711E-07 0.000000000000000E+00 z1= 2 -.107212794327356E-06 0.000000000000000E+00 z1= 3 -.825990474597924E-02 0.000000000000000E+00 alpha(00000128)=0.000000000000000E+00 beta (00000129)=0.127278125693853E+02 gamma(00000129)=0.127278125693853E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 129 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000129)=0.000000000000000E+00 beta (00000130)=0.130491571189365E+02 gamma(00000130)=0.130491571189365E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 130 z1= 1 0.461662369704435E-07 0.000000000000000E+00 z1= 2 0.106014498750875E-06 0.000000000000000E+00 z1= 3 0.813358340803020E-02 0.000000000000000E+00 alpha(00000130)=0.000000000000000E+00 beta (00000131)=0.130564085759660E+02 gamma(00000131)=0.130564085759660E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 131 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000131)=0.000000000000000E+00 beta (00000132)=0.136082468782782E+02 gamma(00000132)=0.136082468782782E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 132 z1= 1 -.417771936316036E-07 0.000000000000000E+00 z1= 2 -.102022624246315E-06 0.000000000000000E+00 z1= 3 -.780708648502408E-02 0.000000000000000E+00 alpha(00000132)=0.000000000000000E+00 beta (00000133)=0.122641339995452E+02 gamma(00000133)=0.122641339995452E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 133 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000133)=0.000000000000000E+00 beta (00000134)=0.133450912828714E+02 gamma(00000134)=0.133450912828714E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 134 z1= 1 0.422531023138578E-07 0.000000000000000E+00 z1= 2 0.989953776531563E-07 0.000000000000000E+00 z1= 3 0.713742168613939E-02 0.000000000000000E+00 alpha(00000134)=0.000000000000000E+00 beta (00000135)=0.129189968722047E+02 gamma(00000135)=0.129189968722047E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 135 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000135)=0.000000000000000E+00 beta (00000136)=0.133088304379374E+02 gamma(00000136)=0.133088304379374E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 136 z1= 1 -.504571106806073E-07 0.000000000000000E+00 z1= 2 -.105536791413646E-06 0.000000000000000E+00 z1= 3 -.681475564902163E-02 0.000000000000000E+00 alpha(00000136)=0.000000000000000E+00 beta (00000137)=0.119893051266616E+02 gamma(00000137)=0.119893051266616E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 137 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000137)=0.000000000000000E+00 beta (00000138)=0.134043262043172E+02 gamma(00000138)=0.134043262043172E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 138 z1= 1 0.499311967137178E-07 0.000000000000000E+00 z1= 2 0.100410355287350E-06 0.000000000000000E+00 z1= 3 0.596163503164671E-02 0.000000000000000E+00 alpha(00000138)=0.000000000000000E+00 beta (00000139)=0.129875628054342E+02 gamma(00000139)=0.129875628054342E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 139 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000139)=0.000000000000000E+00 beta (00000140)=0.133426472343340E+02 gamma(00000140)=0.133426472343340E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 140 z1= 1 -.531057118679373E-07 0.000000000000000E+00 z1= 2 -.103393603140961E-06 0.000000000000000E+00 z1= 3 -.573467270441902E-02 0.000000000000000E+00 alpha(00000140)=0.000000000000000E+00 beta (00000141)=0.130003727948629E+02 gamma(00000141)=0.130003727948629E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 141 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000141)=0.000000000000000E+00 beta (00000142)=0.134435865600151E+02 gamma(00000142)=0.134435865600151E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 142 z1= 1 0.589621949702301E-07 0.000000000000000E+00 z1= 2 0.107775900272042E-06 0.000000000000000E+00 z1= 3 0.582661743895352E-02 0.000000000000000E+00 alpha(00000142)=0.000000000000000E+00 beta (00000143)=0.125646157469269E+02 gamma(00000143)=0.125646157469269E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 143 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000143)=0.000000000000000E+00 beta (00000144)=0.137008225011311E+02 gamma(00000144)=0.137008225011311E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 144 z1= 1 -.562510776222491E-07 0.000000000000000E+00 z1= 2 -.102442783202553E-06 0.000000000000000E+00 z1= 3 -.579861117830149E-02 0.000000000000000E+00 alpha(00000144)=0.000000000000000E+00 beta (00000145)=0.132286707030919E+02 gamma(00000145)=0.132286707030919E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 145 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000145)=0.000000000000000E+00 beta (00000146)=0.139206133529813E+02 gamma(00000146)=0.139206133529813E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 146 z1= 1 0.546786025181281E-07 0.000000000000000E+00 z1= 2 0.100124853676282E-06 0.000000000000000E+00 z1= 3 0.599594129155231E-02 0.000000000000000E+00 alpha(00000146)=0.000000000000000E+00 beta (00000147)=0.127797039811010E+02 gamma(00000147)=0.127797039811010E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 147 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000147)=0.000000000000000E+00 beta (00000148)=0.129455476818412E+02 gamma(00000148)=0.129455476818412E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 148 z1= 1 -.605728138654282E-07 0.000000000000000E+00 z1= 2 -.105920575824148E-06 0.000000000000000E+00 z1= 3 -.646284523544069E-02 0.000000000000000E+00 alpha(00000148)=0.000000000000000E+00 beta (00000149)=0.129403299689037E+02 gamma(00000149)=0.129403299689037E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 149 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000149)=0.000000000000000E+00 beta (00000150)=0.130980300707083E+02 gamma(00000150)=0.130980300707083E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 150 z1= 1 0.617621657376249E-07 0.000000000000000E+00 z1= 2 0.108446841205929E-06 0.000000000000000E+00 z1= 3 0.673196257490076E-02 0.000000000000000E+00 alpha(00000150)=0.000000000000000E+00 beta (00000151)=0.128424230104957E+02 gamma(00000151)=0.128424230104957E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 151 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000151)=0.000000000000000E+00 beta (00000152)=0.139447997300137E+02 gamma(00000152)=0.139447997300137E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 152 z1= 1 -.475373083562089E-07 0.000000000000000E+00 z1= 2 -.945708536924036E-07 0.000000000000000E+00 z1= 3 -.644031539102055E-02 0.000000000000000E+00 alpha(00000152)=0.000000000000000E+00 beta (00000153)=0.124657943204555E+02 gamma(00000153)=0.124657943204555E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 153 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000153)=0.000000000000000E+00 beta (00000154)=0.135700262398937E+02 gamma(00000154)=0.135700262398937E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 154 z1= 1 0.297026833389474E-07 0.000000000000000E+00 z1= 2 0.775003166980301E-07 0.000000000000000E+00 z1= 3 0.616272678936576E-02 0.000000000000000E+00 alpha(00000154)=0.000000000000000E+00 beta (00000155)=0.124067850715580E+02 gamma(00000155)=0.124067850715580E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 155 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000155)=0.000000000000000E+00 beta (00000156)=0.132267188038472E+02 gamma(00000156)=0.132267188038472E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 156 z1= 1 -.114632974267462E-07 0.000000000000000E+00 z1= 2 -.614869194023523E-07 0.000000000000000E+00 z1= 3 -.595885138075806E-02 0.000000000000000E+00 alpha(00000156)=0.000000000000000E+00 beta (00000157)=0.125236520832054E+02 gamma(00000157)=0.125236520832054E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 157 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000157)=0.000000000000000E+00 beta (00000158)=0.135215449895815E+02 gamma(00000158)=0.135215449895815E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 158 z1= 1 -.290455891976960E-08 0.000000000000000E+00 z1= 2 0.482625638984630E-07 0.000000000000000E+00 z1= 3 0.552074991044421E-02 0.000000000000000E+00 alpha(00000158)=0.000000000000000E+00 beta (00000159)=0.127881279059966E+02 gamma(00000159)=0.127881279059966E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 159 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000159)=0.000000000000000E+00 beta (00000160)=0.139485769146951E+02 gamma(00000160)=0.139485769146951E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 160 z1= 1 0.101369597134762E-07 0.000000000000000E+00 z1= 2 -.404685151804071E-07 0.000000000000000E+00 z1= 3 -.498079920393744E-02 0.000000000000000E+00 alpha(00000160)=0.000000000000000E+00 beta (00000161)=0.127763310054266E+02 gamma(00000161)=0.127763310054266E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 161 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000161)=0.000000000000000E+00 beta (00000162)=0.130878491126253E+02 gamma(00000162)=0.130878491126253E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 162 z1= 1 -.141178479679330E-07 0.000000000000000E+00 z1= 2 0.381799476418046E-07 0.000000000000000E+00 z1= 3 0.478114082316547E-02 0.000000000000000E+00 alpha(00000162)=0.000000000000000E+00 beta (00000163)=0.131378771013455E+02 gamma(00000163)=0.131378771013455E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 163 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000163)=0.000000000000000E+00 beta (00000164)=0.129852875585512E+02 gamma(00000164)=0.129852875585512E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 164 z1= 1 0.154378805693883E-07 0.000000000000000E+00 z1= 2 -.391822628405258E-07 0.000000000000000E+00 z1= 3 -.443841015556029E-02 0.000000000000000E+00 alpha(00000164)=0.000000000000000E+00 beta (00000165)=0.126250382836200E+02 gamma(00000165)=0.126250382836200E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 165 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000165)=0.000000000000000E+00 beta (00000166)=0.133717534007553E+02 gamma(00000166)=0.133717534007553E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 166 z1= 1 -.188807706604649E-07 0.000000000000000E+00 z1= 2 0.348664333507318E-07 0.000000000000000E+00 z1= 3 0.346203820632514E-02 0.000000000000000E+00 alpha(00000166)=0.000000000000000E+00 beta (00000167)=0.127608899803478E+02 gamma(00000167)=0.127608899803478E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 167 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000167)=0.000000000000000E+00 beta (00000168)=0.141892523491337E+02 gamma(00000168)=0.141892523491337E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 168 z1= 1 0.245546596571236E-07 0.000000000000000E+00 z1= 2 -.266097268429924E-07 0.000000000000000E+00 z1= 3 -.250641959007140E-02 0.000000000000000E+00 alpha(00000168)=0.000000000000000E+00 beta (00000169)=0.122983044485583E+02 gamma(00000169)=0.122983044485583E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 169 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000169)=0.000000000000000E+00 beta (00000170)=0.136209307648119E+02 gamma(00000170)=0.136209307648119E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 170 z1= 1 -.273222004829737E-07 0.000000000000000E+00 z1= 2 0.215341163746149E-07 0.000000000000000E+00 z1= 3 0.191505315209640E-02 0.000000000000000E+00 alpha(00000170)=0.000000000000000E+00 beta (00000171)=0.122697382590764E+02 gamma(00000171)=0.122697382590764E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 171 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000171)=0.000000000000000E+00 beta (00000172)=0.129523594454256E+02 gamma(00000172)=0.129523594454256E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 172 z1= 1 0.280407124490442E-07 0.000000000000000E+00 z1= 2 -.202078080987350E-07 0.000000000000000E+00 z1= 3 -.169675963990711E-02 0.000000000000000E+00 alpha(00000172)=0.000000000000000E+00 beta (00000173)=0.122351735053637E+02 gamma(00000173)=0.122351735053637E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 173 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000173)=0.000000000000000E+00 beta (00000174)=0.139756745403560E+02 gamma(00000174)=0.139756745403560E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 174 z1= 1 -.279794813455234E-07 0.000000000000000E+00 z1= 2 0.164006447719509E-07 0.000000000000000E+00 z1= 3 0.133511626433149E-02 0.000000000000000E+00 alpha(00000174)=0.000000000000000E+00 beta (00000175)=0.129307168832891E+02 gamma(00000175)=0.129307168832891E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 175 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000175)=0.000000000000000E+00 beta (00000176)=0.132725174994354E+02 gamma(00000176)=0.132725174994354E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 176 z1= 1 0.234202328355457E-07 0.000000000000000E+00 z1= 2 -.209829950307411E-07 0.000000000000000E+00 z1= 3 -.112920101502908E-02 0.000000000000000E+00 alpha(00000176)=0.000000000000000E+00 beta (00000177)=0.125054745133195E+02 gamma(00000177)=0.125054745133195E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 177 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000177)=0.000000000000000E+00 beta (00000178)=0.133813259867235E+02 gamma(00000178)=0.133813259867235E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 178 z1= 1 -.141126159786120E-07 0.000000000000000E+00 z1= 2 0.276490000382726E-07 0.000000000000000E+00 z1= 3 0.826272072638596E-03 0.000000000000000E+00 alpha(00000178)=0.000000000000000E+00 beta (00000179)=0.126357145883594E+02 gamma(00000179)=0.126357145883594E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 179 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000179)=0.000000000000000E+00 beta (00000180)=0.131777764776065E+02 gamma(00000180)=0.131777764776065E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 180 z1= 1 0.101984517515002E-07 0.000000000000000E+00 z1= 2 -.306411912375133E-07 0.000000000000000E+00 z1= 3 -.421343612431898E-03 0.000000000000000E+00 alpha(00000180)=0.000000000000000E+00 beta (00000181)=0.126295208461702E+02 gamma(00000181)=0.126295208461702E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 181 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000181)=0.000000000000000E+00 beta (00000182)=0.132336330613853E+02 gamma(00000182)=0.132336330613853E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 182 z1= 1 -.693464606658228E-08 0.000000000000000E+00 z1= 2 0.325974914682642E-07 0.000000000000000E+00 z1= 3 -.141119123169439E-03 0.000000000000000E+00 alpha(00000182)=0.000000000000000E+00 beta (00000183)=0.129114612084022E+02 gamma(00000183)=0.129114612084022E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 183 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000183)=0.000000000000000E+00 beta (00000184)=0.135800892495267E+02 gamma(00000184)=0.135800892495267E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 184 z1= 1 0.126149110966228E-07 0.000000000000000E+00 z1= 2 -.273738448436367E-07 0.000000000000000E+00 z1= 3 0.756167970362077E-03 0.000000000000000E+00 alpha(00000184)=0.000000000000000E+00 beta (00000185)=0.129480129912480E+02 gamma(00000185)=0.129480129912480E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 185 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000185)=0.000000000000000E+00 beta (00000186)=0.136308602255034E+02 gamma(00000186)=0.136308602255034E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 186 z1= 1 -.173505073988722E-07 0.000000000000000E+00 z1= 2 0.224573922340265E-07 0.000000000000000E+00 z1= 3 -.114708292093542E-02 0.000000000000000E+00 alpha(00000186)=0.000000000000000E+00 beta (00000187)=0.125086692129316E+02 gamma(00000187)=0.125086692129316E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 187 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000187)=0.000000000000000E+00 beta (00000188)=0.136340950215916E+02 gamma(00000188)=0.136340950215916E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 188 z1= 1 0.110850540092564E-07 0.000000000000000E+00 z1= 2 -.253889641576091E-07 0.000000000000000E+00 z1= 3 0.136070267586533E-02 0.000000000000000E+00 alpha(00000188)=0.000000000000000E+00 beta (00000189)=0.126286709212877E+02 gamma(00000189)=0.126286709212877E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 189 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000189)=0.000000000000000E+00 beta (00000190)=0.134171165975725E+02 gamma(00000190)=0.134171165975725E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 190 z1= 1 -.386430744347965E-08 0.000000000000000E+00 z1= 2 0.300278967879999E-07 0.000000000000000E+00 z1= 3 -.161830863606063E-02 0.000000000000000E+00 alpha(00000190)=0.000000000000000E+00 beta (00000191)=0.124710813887208E+02 gamma(00000191)=0.124710813887208E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 191 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000191)=0.000000000000000E+00 beta (00000192)=0.136215035622288E+02 gamma(00000192)=0.136215035622288E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 192 z1= 1 0.127142574767036E-08 0.000000000000000E+00 z1= 2 -.300246755344409E-07 0.000000000000000E+00 z1= 3 0.180517700804194E-02 0.000000000000000E+00 alpha(00000192)=0.000000000000000E+00 beta (00000193)=0.130478556640672E+02 gamma(00000193)=0.130478556640672E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 193 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000193)=0.000000000000000E+00 beta (00000194)=0.130881990929750E+02 gamma(00000194)=0.130881990929750E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 194 z1= 1 -.361263350831531E-08 0.000000000000000E+00 z1= 2 0.287845080201854E-07 0.000000000000000E+00 z1= 3 -.218370342664769E-02 0.000000000000000E+00 alpha(00000194)=0.000000000000000E+00 beta (00000195)=0.133222093490050E+02 gamma(00000195)=0.133222093490050E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 195 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000195)=0.000000000000000E+00 beta (00000196)=0.134810896913900E+02 gamma(00000196)=0.134810896913900E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 196 z1= 1 0.299994521932301E-08 0.000000000000000E+00 z1= 2 -.293497224644439E-07 0.000000000000000E+00 z1= 3 0.212244815287242E-02 0.000000000000000E+00 alpha(00000196)=0.000000000000000E+00 beta (00000197)=0.132472204053632E+02 gamma(00000197)=0.132472204053632E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 197 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000197)=0.000000000000000E+00 beta (00000198)=0.130644092193561E+02 gamma(00000198)=0.130644092193561E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 198 z1= 1 0.448392181631035E-08 0.000000000000000E+00 z1= 2 0.363002407911296E-07 0.000000000000000E+00 z1= 3 -.184138903196123E-02 0.000000000000000E+00 alpha(00000198)=0.000000000000000E+00 beta (00000199)=0.119855521806933E+02 gamma(00000199)=0.119855521806933E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 199 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000199)=0.000000000000000E+00 beta (00000200)=0.135632945091271E+02 gamma(00000200)=0.135632945091271E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 200 z1= 1 -.184433270149220E-07 0.000000000000000E+00 z1= 2 -.442778794072438E-07 0.000000000000000E+00 z1= 3 0.105281484114242E-02 0.000000000000000E+00 alpha(00000200)=0.000000000000000E+00 beta (00000201)=0.127088705698804E+02 gamma(00000201)=0.127088705698804E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 201 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000201)=0.000000000000000E+00 beta (00000202)=0.138555330357000E+02 gamma(00000202)=0.138555330357000E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 202 z1= 1 0.293007118320858E-07 0.000000000000000E+00 z1= 2 0.509089115451229E-07 0.000000000000000E+00 z1= 3 -.269591497667347E-03 0.000000000000000E+00 alpha(00000202)=0.000000000000000E+00 beta (00000203)=0.126095872250618E+02 gamma(00000203)=0.126095872250618E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 203 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000203)=0.000000000000000E+00 beta (00000204)=0.134126309764336E+02 gamma(00000204)=0.134126309764336E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 204 z1= 1 -.387353468844602E-07 0.000000000000000E+00 z1= 2 -.573724278280820E-07 0.000000000000000E+00 z1= 3 -.321686059014106E-03 0.000000000000000E+00 alpha(00000204)=0.000000000000000E+00 beta (00000205)=0.123936091084825E+02 gamma(00000205)=0.123936091084825E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 205 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000205)=0.000000000000000E+00 beta (00000206)=0.129976855250292E+02 gamma(00000206)=0.129976855250292E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 206 z1= 1 0.479624154797569E-07 0.000000000000000E+00 z1= 2 0.634156295817659E-07 0.000000000000000E+00 z1= 3 0.974406418649940E-03 0.000000000000000E+00 alpha(00000206)=0.000000000000000E+00 beta (00000207)=0.122480879369075E+02 gamma(00000207)=0.122480879369075E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 207 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000207)=0.000000000000000E+00 beta (00000208)=0.134240964954857E+02 gamma(00000208)=0.134240964954857E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 208 z1= 1 -.525961860757193E-07 0.000000000000000E+00 z1= 2 -.649235033173615E-07 0.000000000000000E+00 z1= 3 -.164571634486982E-02 0.000000000000000E+00 alpha(00000208)=0.000000000000000E+00 beta (00000209)=0.126747674848974E+02 gamma(00000209)=0.126747674848974E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 209 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000209)=0.000000000000000E+00 beta (00000210)=0.134540284860495E+02 gamma(00000210)=0.134540284860495E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 210 z1= 1 0.713789526647461E-07 0.000000000000000E+00 z1= 2 0.786003844380559E-07 0.000000000000000E+00 z1= 3 0.281909538141851E-02 0.000000000000000E+00 alpha(00000210)=0.000000000000000E+00 beta (00000211)=0.123270998598659E+02 gamma(00000211)=0.123270998598659E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 211 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000211)=0.000000000000000E+00 beta (00000212)=0.129888485389636E+02 gamma(00000212)=0.129888485389636E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 212 z1= 1 -.975226521577818E-07 0.000000000000000E+00 z1= 2 -.989823164335157E-07 0.000000000000000E+00 z1= 3 -.388858728186379E-02 0.000000000000000E+00 alpha(00000212)=0.000000000000000E+00 beta (00000213)=0.130784536681443E+02 gamma(00000213)=0.130784536681443E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 213 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000213)=0.000000000000000E+00 beta (00000214)=0.133370741227568E+02 gamma(00000214)=0.133370741227568E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 214 z1= 1 0.123447064809528E-06 0.000000000000000E+00 z1= 2 0.119911401021307E-06 0.000000000000000E+00 z1= 3 0.442280289371365E-02 0.000000000000000E+00 alpha(00000214)=0.000000000000000E+00 beta (00000215)=0.122604407775853E+02 gamma(00000215)=0.122604407775853E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 215 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000215)=0.000000000000000E+00 beta (00000216)=0.135149443933753E+02 gamma(00000216)=0.135149443933753E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 216 z1= 1 -.123968140525090E-06 0.000000000000000E+00 z1= 2 -.118621354886286E-06 0.000000000000000E+00 z1= 3 -.413644457263078E-02 0.000000000000000E+00 alpha(00000216)=0.000000000000000E+00 beta (00000217)=0.130597396265309E+02 gamma(00000217)=0.130597396265309E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 217 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000217)=0.000000000000000E+00 beta (00000218)=0.134738740181932E+02 gamma(00000218)=0.134738740181932E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 218 z1= 1 0.119030156269222E-06 0.000000000000000E+00 z1= 2 0.114656311076076E-06 0.000000000000000E+00 z1= 3 0.364134989845550E-02 0.000000000000000E+00 alpha(00000218)=0.000000000000000E+00 beta (00000219)=0.123569725584347E+02 gamma(00000219)=0.123569725584347E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 219 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000219)=0.000000000000000E+00 beta (00000220)=0.139261589976104E+02 gamma(00000220)=0.139261589976104E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 220 z1= 1 -.104646549728155E-06 0.000000000000000E+00 z1= 2 -.101350701237762E-06 0.000000000000000E+00 z1= 3 -.264218369186144E-02 0.000000000000000E+00 alpha(00000220)=0.000000000000000E+00 beta (00000221)=0.127827361336816E+02 gamma(00000221)=0.127827361336816E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 221 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000221)=0.000000000000000E+00 beta (00000222)=0.132363281046701E+02 gamma(00000222)=0.132363281046701E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 222 z1= 1 0.876063880514942E-07 0.000000000000000E+00 z1= 2 0.878630284227751E-07 0.000000000000000E+00 z1= 3 0.182436501721766E-02 0.000000000000000E+00 alpha(00000222)=0.000000000000000E+00 beta (00000223)=0.126638484183082E+02 gamma(00000223)=0.126638484183082E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 223 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000223)=0.000000000000000E+00 beta (00000224)=0.133440130555143E+02 gamma(00000224)=0.133440130555143E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 224 z1= 1 -.638999437664427E-07 0.000000000000000E+00 z1= 2 -.689110447558983E-07 0.000000000000000E+00 z1= 3 -.101409397396015E-02 0.000000000000000E+00 alpha(00000224)=0.000000000000000E+00 beta (00000225)=0.129139439055612E+02 gamma(00000225)=0.129139439055612E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 225 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000225)=0.000000000000000E+00 beta (00000226)=0.135823734913803E+02 gamma(00000226)=0.135823734913803E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 226 z1= 1 0.471909302681046E-07 0.000000000000000E+00 z1= 2 0.555304601576774E-07 0.000000000000000E+00 z1= 3 0.366239911114586E-03 0.000000000000000E+00 alpha(00000226)=0.000000000000000E+00 beta (00000227)=0.126079354273103E+02 gamma(00000227)=0.126079354273103E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 227 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000227)=0.000000000000000E+00 beta (00000228)=0.134590200619833E+02 gamma(00000228)=0.134590200619833E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 228 z1= 1 -.291339261005927E-07 0.000000000000000E+00 z1= 2 -.410199600103106E-07 0.000000000000000E+00 z1= 3 0.425707573923413E-03 0.000000000000000E+00 alpha(00000228)=0.000000000000000E+00 beta (00000229)=0.126354586613043E+02 gamma(00000229)=0.126354586613043E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 229 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000229)=0.000000000000000E+00 beta (00000230)=0.132693324005011E+02 gamma(00000230)=0.132693324005011E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 230 z1= 1 0.213434305611215E-07 0.000000000000000E+00 z1= 2 0.347283404078351E-07 0.000000000000000E+00 z1= 3 -.127850067020262E-02 0.000000000000000E+00 alpha(00000230)=0.000000000000000E+00 beta (00000231)=0.128192378542162E+02 gamma(00000231)=0.128192378542162E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 231 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000231)=0.000000000000000E+00 beta (00000232)=0.131443059602966E+02 gamma(00000232)=0.131443059602966E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 232 z1= 1 -.221793217615625E-07 0.000000000000000E+00 z1= 2 -.352555514300697E-07 0.000000000000000E+00 z1= 3 0.213925375192667E-02 0.000000000000000E+00 alpha(00000232)=0.000000000000000E+00 beta (00000233)=0.117134997313608E+02 gamma(00000233)=0.117134997313608E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 233 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000233)=0.000000000000000E+00 beta (00000234)=0.134181402329122E+02 gamma(00000234)=0.134181402329122E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 234 z1= 1 0.200334499744423E-07 0.000000000000000E+00 z1= 2 0.314737351682273E-07 0.000000000000000E+00 z1= 3 -.300841716003425E-02 0.000000000000000E+00 alpha(00000234)=0.000000000000000E+00 beta (00000235)=0.127029973730326E+02 gamma(00000235)=0.127029973730326E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 235 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000235)=0.000000000000000E+00 beta (00000236)=0.131889498296536E+02 gamma(00000236)=0.131889498296536E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 236 z1= 1 -.286111958287642E-07 0.000000000000000E+00 z1= 2 -.376515961301744E-07 0.000000000000000E+00 z1= 3 0.368971601565859E-02 0.000000000000000E+00 alpha(00000236)=0.000000000000000E+00 beta (00000237)=0.130424590779911E+02 gamma(00000237)=0.130424590779911E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 237 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000237)=0.000000000000000E+00 beta (00000238)=0.136080428999331E+02 gamma(00000238)=0.136080428999331E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 238 z1= 1 0.387979640081859E-07 0.000000000000000E+00 z1= 2 0.453976434287677E-07 0.000000000000000E+00 z1= 3 -.399887091799870E-02 0.000000000000000E+00 alpha(00000238)=0.000000000000000E+00 beta (00000239)=0.127357059474194E+02 gamma(00000239)=0.127357059474194E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 239 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000239)=0.000000000000000E+00 beta (00000240)=0.139159999620056E+02 gamma(00000240)=0.139159999620056E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 240 z1= 1 -.409299713739764E-07 0.000000000000000E+00 z1= 2 -.458798553580088E-07 0.000000000000000E+00 z1= 3 0.414401885257851E-02 0.000000000000000E+00 alpha(00000240)=0.000000000000000E+00 beta (00000241)=0.129912824790730E+02 gamma(00000241)=0.129912824790730E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 241 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000241)=0.000000000000000E+00 beta (00000242)=0.135235882991858E+02 gamma(00000242)=0.135235882991858E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 242 z1= 1 0.509639743418930E-07 0.000000000000000E+00 z1= 2 0.531215362327593E-07 0.000000000000000E+00 z1= 3 -.423843948610755E-02 0.000000000000000E+00 alpha(00000242)=0.000000000000000E+00 beta (00000243)=0.129327814032451E+02 gamma(00000243)=0.129327814032451E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 243 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000243)=0.000000000000000E+00 beta (00000244)=0.132305693338865E+02 gamma(00000244)=0.132305693338865E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 244 z1= 1 -.748861834322725E-07 0.000000000000000E+00 z1= 2 -.714440991744607E-07 0.000000000000000E+00 z1= 3 0.419039785939977E-02 0.000000000000000E+00 alpha(00000244)=0.000000000000000E+00 beta (00000245)=0.126386920882339E+02 gamma(00000245)=0.126386920882339E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 245 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000245)=0.000000000000000E+00 beta (00000246)=0.135992476830361E+02 gamma(00000246)=0.135992476830361E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 246 z1= 1 0.966263982772088E-07 0.000000000000000E+00 z1= 2 0.879773737242316E-07 0.000000000000000E+00 z1= 3 -.393031348342774E-02 0.000000000000000E+00 alpha(00000246)=0.000000000000000E+00 beta (00000247)=0.128189000999111E+02 gamma(00000247)=0.128189000999111E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 247 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000247)=0.000000000000000E+00 beta (00000248)=0.131440863968019E+02 gamma(00000248)=0.131440863968019E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 248 z1= 1 -.114656730760328E-06 0.000000000000000E+00 z1= 2 -.101774474138647E-06 0.000000000000000E+00 z1= 3 0.384416227636596E-02 0.000000000000000E+00 alpha(00000248)=0.000000000000000E+00 beta (00000249)=0.123936879881943E+02 gamma(00000249)=0.123936879881943E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 249 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000249)=0.000000000000000E+00 beta (00000250)=0.131791225258706E+02 gamma(00000250)=0.131791225258706E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 250 z1= 1 0.126276433972099E-06 0.000000000000000E+00 z1= 2 0.110194318222968E-06 0.000000000000000E+00 z1= 3 -.356726615972240E-02 0.000000000000000E+00 alpha(00000250)=0.000000000000000E+00 beta (00000251)=0.127446125940576E+02 gamma(00000251)=0.127446125940576E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 251 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000251)=0.000000000000000E+00 beta (00000252)=0.131600494788006E+02 gamma(00000252)=0.131600494788006E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 252 z1= 1 -.148075918180758E-06 0.000000000000000E+00 z1= 2 -.127438773080525E-06 0.000000000000000E+00 z1= 3 0.344841093064163E-02 0.000000000000000E+00 alpha(00000252)=0.000000000000000E+00 beta (00000253)=0.120942977504039E+02 gamma(00000253)=0.120942977504039E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 253 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000253)=0.000000000000000E+00 beta (00000254)=0.130884891987253E+02 gamma(00000254)=0.130884891987253E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 254 z1= 1 0.168593334814917E-06 0.000000000000000E+00 z1= 2 0.143220496632212E-06 0.000000000000000E+00 z1= 3 -.332402486098547E-02 0.000000000000000E+00 alpha(00000254)=0.000000000000000E+00 beta (00000255)=0.122949788180572E+02 gamma(00000255)=0.122949788180572E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 255 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000255)=0.000000000000000E+00 beta (00000256)=0.133715020782044E+02 gamma(00000256)=0.133715020782044E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 256 z1= 1 -.187619167527162E-06 0.000000000000000E+00 z1= 2 -.157285393987284E-06 0.000000000000000E+00 z1= 3 0.309773367572223E-02 0.000000000000000E+00 alpha(00000256)=0.000000000000000E+00 beta (00000257)=0.126643112022147E+02 gamma(00000257)=0.126643112022147E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 257 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000257)=0.000000000000000E+00 beta (00000258)=0.133399982989222E+02 gamma(00000258)=0.133399982989222E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 258 z1= 1 0.202218959780790E-06 0.000000000000000E+00 z1= 2 0.168201534413333E-06 0.000000000000000E+00 z1= 3 -.303373919933938E-02 0.000000000000000E+00 alpha(00000258)=0.000000000000000E+00 beta (00000259)=0.127509076065417E+02 gamma(00000259)=0.127509076065417E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 259 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000259)=0.000000000000000E+00 beta (00000260)=0.139527186865674E+02 gamma(00000260)=0.139527186865674E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 260 z1= 1 -.202412156727946E-06 0.000000000000000E+00 z1= 2 -.167840345877222E-06 0.000000000000000E+00 z1= 3 0.310646292106809E-02 0.000000000000000E+00 alpha(00000260)=0.000000000000000E+00 beta (00000261)=0.124301999171040E+02 gamma(00000261)=0.124301999171040E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 261 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000261)=0.000000000000000E+00 beta (00000262)=0.133556347353915E+02 gamma(00000262)=0.133556347353915E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 262 z1= 1 0.212616584387149E-06 0.000000000000000E+00 z1= 2 0.175442644286287E-06 0.000000000000000E+00 z1= 3 -.326168536078373E-02 0.000000000000000E+00 alpha(00000262)=0.000000000000000E+00 beta (00000263)=0.132288216164782E+02 gamma(00000263)=0.132288216164782E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 263 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000263)=0.000000000000000E+00 beta (00000264)=0.133124754124167E+02 gamma(00000264)=0.133124754124167E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 264 z1= 1 -.241135471697879E-06 0.000000000000000E+00 z1= 2 -.197557864555940E-06 0.000000000000000E+00 z1= 3 0.359796656458346E-02 0.000000000000000E+00 alpha(00000264)=0.000000000000000E+00 beta (00000265)=0.127892310642588E+02 gamma(00000265)=0.127892310642588E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 265 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000265)=0.000000000000000E+00 beta (00000266)=0.131292666315659E+02 gamma(00000266)=0.131292666315659E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 266 z1= 1 0.263788421017187E-06 0.000000000000000E+00 z1= 2 0.214849111302004E-06 0.000000000000000E+00 z1= 3 -.364978142572900E-02 0.000000000000000E+00 alpha(00000266)=0.000000000000000E+00 beta (00000267)=0.123433190597605E+02 gamma(00000267)=0.123433190597605E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 267 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000267)=0.000000000000000E+00 beta (00000268)=0.133992205155856E+02 gamma(00000268)=0.133992205155856E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 268 z1= 1 -.268146048924139E-06 0.000000000000000E+00 z1= 2 -.217878308289869E-06 0.000000000000000E+00 z1= 3 0.355413367714071E-02 0.000000000000000E+00 alpha(00000268)=0.000000000000000E+00 beta (00000269)=0.122540230038864E+02 gamma(00000269)=0.122540230038864E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 269 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000269)=0.000000000000000E+00 beta (00000270)=0.138495024516051E+02 gamma(00000270)=0.138495024516051E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 270 z1= 1 0.260567067886762E-06 0.000000000000000E+00 z1= 2 0.211212773417553E-06 0.000000000000000E+00 z1= 3 -.332259693586184E-02 0.000000000000000E+00 alpha(00000270)=0.000000000000000E+00 beta (00000271)=0.126404622835608E+02 gamma(00000271)=0.126404622835608E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 271 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000271)=0.000000000000000E+00 beta (00000272)=0.127759004357581E+02 gamma(00000272)=0.127759004357581E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 272 z1= 1 -.284310202047560E-06 0.000000000000000E+00 z1= 2 -.230084254173452E-06 0.000000000000000E+00 z1= 3 0.350762647286992E-02 0.000000000000000E+00 alpha(00000272)=0.000000000000000E+00 beta (00000273)=0.130373811411614E+02 gamma(00000273)=0.130373811411614E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 273 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000273)=0.000000000000000E+00 beta (00000274)=0.133052088760305E+02 gamma(00000274)=0.133052088760305E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 274 z1= 1 0.298999382419840E-06 0.000000000000000E+00 z1= 2 0.241400809847117E-06 0.000000000000000E+00 z1= 3 -.365674961325142E-02 0.000000000000000E+00 alpha(00000274)=0.000000000000000E+00 beta (00000275)=0.120070885386196E+02 gamma(00000275)=0.120070885386196E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 275 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000275)=0.000000000000000E+00 beta (00000276)=0.134357782130017E+02 gamma(00000276)=0.134357782130017E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 276 z1= 1 -.281516696326763E-06 0.000000000000000E+00 z1= 2 -.226972419033623E-06 0.000000000000000E+00 z1= 3 0.340641059783949E-02 0.000000000000000E+00 alpha(00000276)=0.000000000000000E+00 beta (00000277)=0.124719862537067E+02 gamma(00000277)=0.124719862537067E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 277 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000277)=0.000000000000000E+00 beta (00000278)=0.139892814899889E+02 gamma(00000278)=0.139892814899889E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 278 z1= 1 0.264127500781020E-06 0.000000000000000E+00 z1= 2 0.212766194248974E-06 0.000000000000000E+00 z1= 3 -.295149311999892E-02 0.000000000000000E+00 alpha(00000278)=0.000000000000000E+00 beta (00000279)=0.123300998425458E+02 gamma(00000279)=0.123300998425458E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 279 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000279)=0.000000000000000E+00 beta (00000280)=0.130516214053218E+02 gamma(00000280)=0.130516214053218E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 280 z1= 1 -.261512500778893E-06 0.000000000000000E+00 z1= 2 -.211755295976548E-06 0.000000000000000E+00 z1= 3 0.300531021243635E-02 0.000000000000000E+00 alpha(00000280)=0.000000000000000E+00 beta (00000281)=0.131138845574593E+02 gamma(00000281)=0.131138845574593E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 281 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000281)=0.000000000000000E+00 beta (00000282)=0.137452549404901E+02 gamma(00000282)=0.137452549404901E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 282 z1= 1 0.263884961262386E-06 0.000000000000000E+00 z1= 2 0.213122859299550E-06 0.000000000000000E+00 z1= 3 -.295113081846962E-02 0.000000000000000E+00 alpha(00000282)=0.000000000000000E+00 beta (00000283)=0.122835301173960E+02 gamma(00000283)=0.122835301173960E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 283 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000283)=0.000000000000000E+00 beta (00000284)=0.130404614677819E+02 gamma(00000284)=0.130404614677819E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 284 z1= 1 -.263144677353343E-06 0.000000000000000E+00 z1= 2 -.212680738064961E-06 0.000000000000000E+00 z1= 3 0.290273681738163E-02 0.000000000000000E+00 alpha(00000284)=0.000000000000000E+00 beta (00000285)=0.127522204562457E+02 gamma(00000285)=0.127522204562457E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 285 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000285)=0.000000000000000E+00 beta (00000286)=0.136894182563529E+02 gamma(00000286)=0.136894182563529E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 286 z1= 1 0.255651742193637E-06 0.000000000000000E+00 z1= 2 0.205610275930568E-06 0.000000000000000E+00 z1= 3 -.294580483691039E-02 0.000000000000000E+00 alpha(00000286)=0.000000000000000E+00 beta (00000287)=0.124623288960692E+02 gamma(00000287)=0.124623288960692E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 287 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000287)=0.000000000000000E+00 beta (00000288)=0.131296293288262E+02 gamma(00000288)=0.131296293288262E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 288 z1= 1 -.260614929797377E-06 0.000000000000000E+00 z1= 2 -.210466468602297E-06 0.000000000000000E+00 z1= 3 0.289131906939307E-02 0.000000000000000E+00 alpha(00000288)=0.000000000000000E+00 beta (00000289)=0.122922556709104E+02 gamma(00000289)=0.122922556709104E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 289 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000289)=0.000000000000000E+00 beta (00000290)=0.136583276071911E+02 gamma(00000290)=0.136583276071911E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 290 z1= 1 0.242730798759305E-06 0.000000000000000E+00 z1= 2 0.194963185974248E-06 0.000000000000000E+00 z1= 3 -.270168928545332E-02 0.000000000000000E+00 alpha(00000290)=0.000000000000000E+00 beta (00000291)=0.125959777342853E+02 gamma(00000291)=0.125959777342853E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 291 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000291)=0.000000000000000E+00 beta (00000292)=0.133904726541201E+02 gamma(00000292)=0.133904726541201E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 292 z1= 1 -.232596479889102E-06 0.000000000000000E+00 z1= 2 -.188212798518639E-06 0.000000000000000E+00 z1= 3 0.264544988209266E-02 0.000000000000000E+00 alpha(00000292)=0.000000000000000E+00 beta (00000293)=0.127989694253241E+02 gamma(00000293)=0.127989694253241E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 293 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000293)=0.000000000000000E+00 beta (00000294)=0.131715138347941E+02 gamma(00000294)=0.131715138347941E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 294 z1= 1 0.226995049248816E-06 0.000000000000000E+00 z1= 2 0.180905402561099E-06 0.000000000000000E+00 z1= 3 -.244220292803382E-02 0.000000000000000E+00 alpha(00000294)=0.000000000000000E+00 beta (00000295)=0.123387621147162E+02 gamma(00000295)=0.123387621147162E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 295 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000295)=0.000000000000000E+00 beta (00000296)=0.133809342113700E+02 gamma(00000296)=0.133809342113700E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 296 z1= 1 -.224884438069931E-06 0.000000000000000E+00 z1= 2 -.181784715587354E-06 0.000000000000000E+00 z1= 3 0.203833874232854E-02 0.000000000000000E+00 alpha(00000296)=0.000000000000000E+00 beta (00000297)=0.128394503709855E+02 gamma(00000297)=0.128394503709855E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 297 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000297)=0.000000000000000E+00 beta (00000298)=0.133622806722297E+02 gamma(00000298)=0.133622806722297E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 298 z1= 1 0.227355208080610E-06 0.000000000000000E+00 z1= 2 0.179281180890745E-06 0.000000000000000E+00 z1= 3 -.198354861096610E-02 0.000000000000000E+00 alpha(00000298)=0.000000000000000E+00 beta (00000299)=0.123800158326413E+02 gamma(00000299)=0.123800158326413E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 299 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000299)=0.000000000000000E+00 beta (00000300)=0.131906011214554E+02 gamma(00000300)=0.131906011214554E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 300 z1= 1 -.214776054100006E-06 0.000000000000000E+00 z1= 2 -.173814025859319E-06 0.000000000000000E+00 z1= 3 0.213031082040837E-02 0.000000000000000E+00 alpha(00000300)=0.000000000000000E+00 beta (00000301)=0.122150733876841E+02 gamma(00000301)=0.122150733876841E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 301 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000301)=0.000000000000000E+00 beta (00000302)=0.141271365895224E+02 gamma(00000302)=0.141271365895224E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 302 z1= 1 0.172686951587951E-06 0.000000000000000E+00 z1= 2 0.131527812480031E-06 0.000000000000000E+00 z1= 3 -.225869215928947E-02 0.000000000000000E+00 alpha(00000302)=0.000000000000000E+00 beta (00000303)=0.131833422184287E+02 gamma(00000303)=0.131833422184287E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 303 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000303)=0.000000000000000E+00 beta (00000304)=0.138338072701588E+02 gamma(00000304)=0.138338072701588E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 304 z1= 1 -.165469659350144E-06 0.000000000000000E+00 z1= 2 -.134297471177515E-06 0.000000000000000E+00 z1= 3 0.246865751069495E-02 0.000000000000000E+00 alpha(00000304)=0.000000000000000E+00 beta (00000305)=0.122229787001965E+02 gamma(00000305)=0.122229787001965E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 305 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000305)=0.000000000000000E+00 beta (00000306)=0.137090147556647E+02 gamma(00000306)=0.137090147556647E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 306 z1= 1 0.148813422952421E-06 0.000000000000000E+00 z1= 2 0.110448341504869E-06 0.000000000000000E+00 z1= 3 -.228424979483731E-02 0.000000000000000E+00 alpha(00000306)=0.000000000000000E+00 beta (00000307)=0.128786231665490E+02 gamma(00000307)=0.128786231665490E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 307 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000307)=0.000000000000000E+00 beta (00000308)=0.131113685821750E+02 gamma(00000308)=0.131113685821750E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 308 z1= 1 -.151554469975785E-06 0.000000000000000E+00 z1= 2 -.121886152997506E-06 0.000000000000000E+00 z1= 3 0.236356461691746E-02 0.000000000000000E+00 alpha(00000308)=0.000000000000000E+00 beta (00000309)=0.125967905872188E+02 gamma(00000309)=0.125967905872188E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 309 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000309)=0.000000000000000E+00 beta (00000310)=0.132774425037876E+02 gamma(00000310)=0.132774425037876E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 310 z1= 1 0.134391015887254E-06 0.000000000000000E+00 z1= 2 0.969657508563407E-07 0.000000000000000E+00 z1= 3 -.260288958010198E-02 0.000000000000000E+00 alpha(00000310)=0.000000000000000E+00 beta (00000311)=0.124777747153224E+02 gamma(00000311)=0.124777747153224E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 311 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000311)=0.000000000000000E+00 beta (00000312)=0.125472910221259E+02 gamma(00000312)=0.125472910221259E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 312 z1= 1 -.136058757354532E-06 0.000000000000000E+00 z1= 2 -.110100512595640E-06 0.000000000000000E+00 z1= 3 0.280250103771224E-02 0.000000000000000E+00 alpha(00000312)=0.000000000000000E+00 beta (00000313)=0.129541854541084E+02 gamma(00000313)=0.129541854541084E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 313 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000313)=0.000000000000000E+00 beta (00000314)=0.136856570231688E+02 gamma(00000314)=0.136856570231688E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 314 z1= 1 0.111070354735722E-06 0.000000000000000E+00 z1= 2 0.720093273308409E-07 0.000000000000000E+00 z1= 3 -.289835409840216E-02 0.000000000000000E+00 alpha(00000314)=0.000000000000000E+00 beta (00000315)=0.129230608602421E+02 gamma(00000315)=0.129230608602421E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 315 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000315)=0.000000000000000E+00 beta (00000316)=0.138596983346441E+02 gamma(00000316)=0.138596983346441E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 316 z1= 1 -.115053560268384E-06 0.000000000000000E+00 z1= 2 -.965468077621491E-07 0.000000000000000E+00 z1= 3 0.277483306592876E-02 0.000000000000000E+00 alpha(00000316)=0.000000000000000E+00 beta (00000317)=0.131425667723724E+02 gamma(00000317)=0.131425667723724E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 317 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000317)=0.000000000000000E+00 beta (00000318)=0.134602973281562E+02 gamma(00000318)=0.134602973281562E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 318 z1= 1 0.989244967450256E-07 0.000000000000000E+00 z1= 2 0.608527599929055E-07 0.000000000000000E+00 z1= 3 -.261737645031807E-02 0.000000000000000E+00 alpha(00000318)=0.000000000000000E+00 beta (00000319)=0.122042995889335E+02 gamma(00000319)=0.122042995889335E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 319 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000319)=0.000000000000000E+00 beta (00000320)=0.136761012543602E+02 gamma(00000320)=0.136761012543602E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 320 z1= 1 -.939991220715898E-07 0.000000000000000E+00 z1= 2 -.793427116397715E-07 0.000000000000000E+00 z1= 3 0.224905541614039E-02 0.000000000000000E+00 alpha(00000320)=0.000000000000000E+00 beta (00000321)=0.123478380898629E+02 gamma(00000321)=0.123478380898629E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 321 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000321)=0.000000000000000E+00 beta (00000322)=0.138680732997473E+02 gamma(00000322)=0.138680732997473E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 322 z1= 1 0.747532925977597E-07 0.000000000000000E+00 z1= 2 0.420078832378016E-07 0.000000000000000E+00 z1= 3 -.170864632172139E-02 0.000000000000000E+00 alpha(00000322)=0.000000000000000E+00 beta (00000323)=0.131583390352390E+02 gamma(00000323)=0.131583390352390E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 323 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000323)=0.000000000000000E+00 beta (00000324)=0.139107444459598E+02 gamma(00000324)=0.139107444459598E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 324 z1= 1 -.707407284667545E-07 0.000000000000000E+00 z1= 2 -.594417882867878E-07 0.000000000000000E+00 z1= 3 0.134599717873574E-02 0.000000000000000E+00 alpha(00000324)=0.000000000000000E+00 beta (00000325)=0.120600301019404E+02 gamma(00000325)=0.120600301019404E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 325 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000325)=0.000000000000000E+00 beta (00000326)=0.137118715790347E+02 gamma(00000326)=0.137118715790347E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 326 z1= 1 0.383890948260765E-07 0.000000000000000E+00 z1= 2 0.157450337295536E-07 0.000000000000000E+00 z1= 3 -.998873752546209E-03 0.000000000000000E+00 alpha(00000326)=0.000000000000000E+00 beta (00000327)=0.129594085848135E+02 gamma(00000327)=0.129594085848135E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 327 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000327)=0.000000000000000E+00 beta (00000328)=0.139103203461622E+02 gamma(00000328)=0.139103203461622E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 328 z1= 1 -.343986140002536E-07 0.000000000000000E+00 z1= 2 -.267919482851379E-07 0.000000000000000E+00 z1= 3 0.915672483155093E-03 0.000000000000000E+00 alpha(00000328)=0.000000000000000E+00 beta (00000329)=0.117788248189598E+02 gamma(00000329)=0.117788248189598E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 329 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000329)=0.000000000000000E+00 beta (00000330)=0.136103664883380E+02 gamma(00000330)=0.136103664883380E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 330 z1= 1 0.141388795257217E-08 0.000000000000000E+00 z1= 2 -.912935383819385E-08 0.000000000000000E+00 z1= 3 -.104562345323427E-02 0.000000000000000E+00 alpha(00000330)=0.000000000000000E+00 beta (00000331)=0.123989566677113E+02 gamma(00000331)=0.123989566677113E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 331 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000331)=0.000000000000000E+00 beta (00000332)=0.128531916326072E+02 gamma(00000332)=0.128531916326072E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 332 z1= 1 0.226191263590883E-07 0.000000000000000E+00 z1= 2 0.227301168459091E-07 0.000000000000000E+00 z1= 3 0.139908964855618E-02 0.000000000000000E+00 alpha(00000332)=0.000000000000000E+00 beta (00000333)=0.123142903250654E+02 gamma(00000333)=0.123142903250654E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 333 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000333)=0.000000000000000E+00 beta (00000334)=0.140255537866292E+02 gamma(00000334)=0.140255537866292E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 334 z1= 1 -.451382479270260E-07 0.000000000000000E+00 z1= 2 -.461654665372471E-07 0.000000000000000E+00 z1= 3 -.150928013034102E-02 0.000000000000000E+00 alpha(00000334)=0.000000000000000E+00 beta (00000335)=0.123822716140488E+02 gamma(00000335)=0.123822716140488E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 335 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000335)=0.000000000000000E+00 beta (00000336)=0.136337328323146E+02 gamma(00000336)=0.136337328323146E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 336 z1= 1 0.641704965708323E-07 0.000000000000000E+00 z1= 2 0.577471947035466E-07 0.000000000000000E+00 z1= 3 0.152137670397427E-02 0.000000000000000E+00 alpha(00000336)=0.000000000000000E+00 beta (00000337)=0.130406903948893E+02 gamma(00000337)=0.130406903948893E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 337 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000337)=0.000000000000000E+00 beta (00000338)=0.124723794926999E+02 gamma(00000338)=0.124723794926999E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 338 z1= 1 -.786862103374761E-07 0.000000000000000E+00 z1= 2 -.733230295546137E-07 0.000000000000000E+00 z1= 3 -.143597340437186E-02 0.000000000000000E+00 alpha(00000338)=0.000000000000000E+00 beta (00000339)=0.126903322585250E+02 gamma(00000339)=0.126903322585250E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 339 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000339)=0.000000000000000E+00 beta (00000340)=0.139939339474495E+02 gamma(00000340)=0.139939339474495E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 340 z1= 1 0.704095384347582E-07 0.000000000000000E+00 z1= 2 0.652983915154422E-07 0.000000000000000E+00 z1= 3 0.119241110809531E-02 0.000000000000000E+00 alpha(00000340)=0.000000000000000E+00 beta (00000341)=0.128370345133063E+02 gamma(00000341)=0.128370345133063E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 341 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000341)=0.000000000000000E+00 beta (00000342)=0.135358121347515E+02 gamma(00000342)=0.135358121347515E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 342 z1= 1 -.715138320167165E-07 0.000000000000000E+00 z1= 2 -.676465463057696E-07 0.000000000000000E+00 z1= 3 -.993975259397299E-03 0.000000000000000E+00 alpha(00000342)=0.000000000000000E+00 beta (00000343)=0.129228014821815E+02 gamma(00000343)=0.129228014821815E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 343 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000343)=0.000000000000000E+00 beta (00000344)=0.128873468502838E+02 gamma(00000344)=0.128873468502838E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 344 z1= 1 0.833627823050752E-07 0.000000000000000E+00 z1= 2 0.793355197303319E-07 0.000000000000000E+00 z1= 3 0.588256371427727E-03 0.000000000000000E+00 alpha(00000344)=0.000000000000000E+00 beta (00000345)=0.125916255929151E+02 gamma(00000345)=0.125916255929151E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 345 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000345)=0.000000000000000E+00 beta (00000346)=0.138579268278982E+02 gamma(00000346)=0.138579268278982E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 346 z1= 1 -.852117210871649E-07 0.000000000000000E+00 z1= 2 -.797645894607451E-07 0.000000000000000E+00 z1= 3 -.184618679177680E-03 0.000000000000000E+00 alpha(00000346)=0.000000000000000E+00 beta (00000347)=0.127097521627560E+02 gamma(00000347)=0.127097521627560E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 347 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000347)=0.000000000000000E+00 beta (00000348)=0.132917037538730E+02 gamma(00000348)=0.132917037538730E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 348 z1= 1 0.852276715797599E-07 0.000000000000000E+00 z1= 2 0.825128164074656E-07 0.000000000000000E+00 z1= 3 -.315071771257173E-03 0.000000000000000E+00 alpha(00000348)=0.000000000000000E+00 beta (00000349)=0.126857353136077E+02 gamma(00000349)=0.126857353136077E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 349 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000349)=0.000000000000000E+00 beta (00000350)=0.134114704284856E+02 gamma(00000350)=0.134114704284856E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 350 z1= 1 -.735985247763012E-07 0.000000000000000E+00 z1= 2 -.704692289200194E-07 0.000000000000000E+00 z1= 3 0.855966838246474E-03 0.000000000000000E+00 alpha(00000350)=0.000000000000000E+00 beta (00000351)=0.123491413912908E+02 gamma(00000351)=0.123491413912908E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 351 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000351)=0.000000000000000E+00 beta (00000352)=0.133990016879310E+02 gamma(00000352)=0.133990016879310E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 352 z1= 1 0.612923235102992E-07 0.000000000000000E+00 z1= 2 0.660576659506913E-07 0.000000000000000E+00 z1= 3 -.144479549417948E-02 0.000000000000000E+00 alpha(00000352)=0.000000000000000E+00 beta (00000353)=0.118180385979736E+02 gamma(00000353)=0.118180385979736E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 353 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000353)=0.000000000000000E+00 beta (00000354)=0.125672856559603E+02 gamma(00000354)=0.125672856559603E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 354 z1= 1 -.529867752217068E-07 0.000000000000000E+00 z1= 2 -.532075503076638E-07 0.000000000000000E+00 z1= 3 0.188785095819621E-02 0.000000000000000E+00 alpha(00000354)=0.000000000000000E+00 beta (00000355)=0.124082084257940E+02 gamma(00000355)=0.124082084257940E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 355 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000355)=0.000000000000000E+00 beta (00000356)=0.130851982872665E+02 gamma(00000356)=0.130851982872665E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 356 z1= 1 0.699870245137726E-07 0.000000000000000E+00 z1= 2 0.794532273726484E-07 0.000000000000000E+00 z1= 3 -.213025795590374E-02 0.000000000000000E+00 alpha(00000356)=0.000000000000000E+00 beta (00000357)=0.124727988061880E+02 gamma(00000357)=0.124727988061880E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 357 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000357)=0.000000000000000E+00 beta (00000358)=0.136597146996589E+02 gamma(00000358)=0.136597146996589E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 358 z1= 1 -.510515860032540E-07 0.000000000000000E+00 z1= 2 -.436799216754118E-07 0.000000000000000E+00 z1= 3 0.230571976998848E-02 0.000000000000000E+00 alpha(00000358)=0.000000000000000E+00 beta (00000359)=0.127163617231292E+02 gamma(00000359)=0.127163617231292E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 359 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000359)=0.000000000000000E+00 beta (00000360)=0.141509454041257E+02 gamma(00000360)=0.141509454041257E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 360 z1= 1 0.563718574992343E-07 0.000000000000000E+00 z1= 2 0.750671454086875E-07 0.000000000000000E+00 z1= 3 -.221080484401985E-02 0.000000000000000E+00 alpha(00000360)=0.000000000000000E+00 beta (00000361)=0.123982971117123E+02 gamma(00000361)=0.123982971117123E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 361 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000361)=0.000000000000000E+00 beta (00000362)=0.136949524586631E+02 gamma(00000362)=0.136949524586631E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 362 z1= 1 -.281729096643498E-07 0.000000000000000E+00 z1= 2 -.198772733507797E-07 0.000000000000000E+00 z1= 3 0.182300414299421E-02 0.000000000000000E+00 alpha(00000362)=0.000000000000000E+00 beta (00000363)=0.120958996962597E+02 gamma(00000363)=0.120958996962597E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 363 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000363)=0.000000000000000E+00 beta (00000364)=0.137332981784816E+02 gamma(00000364)=0.137332981784816E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 364 z1= 1 0.463886603325613E-07 0.000000000000000E+00 z1= 2 0.733072580437802E-07 0.000000000000000E+00 z1= 3 -.126615036679172E-02 0.000000000000000E+00 alpha(00000364)=0.000000000000000E+00 beta (00000365)=0.130222492006444E+02 gamma(00000365)=0.130222492006444E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 365 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000365)=0.000000000000000E+00 beta (00000366)=0.136368959515742E+02 gamma(00000366)=0.136368959515742E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 366 z1= 1 -.264207201553044E-07 0.000000000000000E+00 z1= 2 -.144885953205645E-07 0.000000000000000E+00 z1= 3 0.636610264597281E-03 0.000000000000000E+00 alpha(00000366)=0.000000000000000E+00 beta (00000367)=0.128318231462960E+02 gamma(00000367)=0.128318231462960E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 367 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000367)=0.000000000000000E+00 beta (00000368)=0.129449014075107E+02 gamma(00000368)=0.129449014075107E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 368 z1= 1 0.670452032731699E-07 0.000000000000000E+00 z1= 2 0.936440073688637E-07 0.000000000000000E+00 z1= 3 0.130541749113762E-03 0.000000000000000E+00 alpha(00000368)=0.000000000000000E+00 beta (00000369)=0.124672260735179E+02 gamma(00000369)=0.124672260735179E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 369 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000369)=0.000000000000000E+00 beta (00000370)=0.134914797760848E+02 gamma(00000370)=0.134914797760848E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 370 z1= 1 -.513202404297045E-07 0.000000000000000E+00 z1= 2 -.301119657925789E-07 0.000000000000000E+00 z1= 3 -.567647807177251E-03 0.000000000000000E+00 alpha(00000370)=0.000000000000000E+00 beta (00000371)=0.122192456179382E+02 gamma(00000371)=0.122192456179382E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 371 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000371)=0.000000000000000E+00 beta (00000372)=0.133995839929760E+02 gamma(00000372)=0.133995839929760E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 372 z1= 1 0.928946289570007E-07 0.000000000000000E+00 z1= 2 0.127383168299221E-06 0.000000000000000E+00 z1= 3 0.114980894834191E-02 0.000000000000000E+00 alpha(00000372)=0.000000000000000E+00 beta (00000373)=0.127020546661906E+02 gamma(00000373)=0.127020546661906E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 373 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000373)=0.000000000000000E+00 beta (00000374)=0.129098948385582E+02 gamma(00000374)=0.129098948385582E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 374 z1= 1 -.453278224828678E-07 0.000000000000000E+00 z1= 2 -.599862914023438E-08 0.000000000000000E+00 z1= 3 -.198234113304376E-02 0.000000000000000E+00 alpha(00000374)=0.000000000000000E+00 beta (00000375)=0.125858432127090E+02 gamma(00000375)=0.125858432127090E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 375 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000375)=0.000000000000000E+00 beta (00000376)=0.134942441498809E+02 gamma(00000376)=0.134942441498809E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 376 z1= 1 0.114346139924184E-06 0.000000000000000E+00 z1= 2 0.178835616465004E-06 0.000000000000000E+00 z1= 3 0.271950797238874E-02 0.000000000000000E+00 alpha(00000376)=0.000000000000000E+00 beta (00000377)=0.124390076002027E+02 gamma(00000377)=0.124390076002027E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 377 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000377)=0.000000000000000E+00 beta (00000378)=0.135548362694690E+02 gamma(00000378)=0.135548362694690E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 378 z1= 1 -.208633154152394E-07 0.000000000000000E+00 z1= 2 0.573801172484715E-07 0.000000000000000E+00 z1= 3 -.329400843907638E-02 0.000000000000000E+00 alpha(00000378)=0.000000000000000E+00 beta (00000379)=0.123900363864595E+02 gamma(00000379)=0.123900363864595E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 379 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000379)=0.000000000000000E+00 beta (00000380)=0.137316513766744E+02 gamma(00000380)=0.137316513766744E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 380 z1= 1 0.141112523614827E-06 0.000000000000000E+00 z1= 2 0.254454866896307E-06 0.000000000000000E+00 z1= 3 0.338871172304394E-02 0.000000000000000E+00 alpha(00000380)=0.000000000000000E+00 beta (00000381)=0.125008898095624E+02 gamma(00000381)=0.125008898095624E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 381 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000381)=0.000000000000000E+00 beta (00000382)=0.126402078739853E+02 gamma(00000382)=0.126402078739853E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 382 z1= 1 0.373882640314262E-07 0.000000000000000E+00 z1= 2 0.175632932737299E-06 0.000000000000000E+00 z1= 3 -.359232049164426E-02 0.000000000000000E+00 alpha(00000382)=0.000000000000000E+00 beta (00000383)=0.127575764124601E+02 gamma(00000383)=0.127575764124601E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 383 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000383)=0.000000000000000E+00 beta (00000384)=0.138654520056358E+02 gamma(00000384)=0.138654520056358E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 384 z1= 1 0.175938789408235E-06 0.000000000000000E+00 z1= 2 0.391035864147349E-06 0.000000000000000E+00 z1= 3 0.332647671166193E-02 0.000000000000000E+00 alpha(00000384)=0.000000000000000E+00 beta (00000385)=0.125012042867820E+02 gamma(00000385)=0.125012042867820E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 385 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000385)=0.000000000000000E+00 beta (00000386)=0.141100358180167E+02 gamma(00000386)=0.141100358180167E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 386 z1= 1 0.133130104862356E-06 0.000000000000000E+00 z1= 2 0.363673784397386E-06 0.000000000000000E+00 z1= 3 -.280575989189789E-02 0.000000000000000E+00 alpha(00000386)=0.000000000000000E+00 beta (00000387)=0.129334556189585E+02 gamma(00000387)=0.129334556189585E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 387 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000387)=0.000000000000000E+00 beta (00000388)=0.141311522113745E+02 gamma(00000388)=0.141311522113745E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 388 z1= 1 0.166670843527333E-06 0.000000000000000E+00 z1= 2 0.413248612691195E-06 0.000000000000000E+00 z1= 3 0.240703080363241E-02 0.000000000000000E+00 alpha(00000388)=0.000000000000000E+00 beta (00000389)=0.122177395408993E+02 gamma(00000389)=0.122177395408993E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 389 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000389)=0.000000000000000E+00 beta (00000390)=0.130053269761596E+02 gamma(00000390)=0.130053269761596E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 390 z1= 1 0.134748439819176E-06 0.000000000000000E+00 z1= 2 0.323944192223095E-06 0.000000000000000E+00 z1= 3 -.228935312582129E-02 0.000000000000000E+00 alpha(00000390)=0.000000000000000E+00 beta (00000391)=0.137143418491902E+02 gamma(00000391)=0.137143418491902E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 391 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000391)=0.000000000000000E+00 beta (00000392)=0.133202528422339E+02 gamma(00000392)=0.133202528422339E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 392 z1= 1 0.113578841035586E-06 0.000000000000000E+00 z1= 2 0.312196299184840E-06 0.000000000000000E+00 z1= 3 0.249499894781624E-02 0.000000000000000E+00 alpha(00000392)=0.000000000000000E+00 beta (00000393)=0.126124004277527E+02 gamma(00000393)=0.126124004277527E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 393 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000393)=0.000000000000000E+00 beta (00000394)=0.130166186885123E+02 gamma(00000394)=0.130166186885123E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 394 z1= 1 0.106012837969554E-06 0.000000000000000E+00 z1= 2 0.223437192690620E-06 0.000000000000000E+00 z1= 3 -.250405766133086E-02 0.000000000000000E+00 alpha(00000394)=0.000000000000000E+00 beta (00000395)=0.132966647669460E+02 gamma(00000395)=0.132966647669460E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 395 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000395)=0.000000000000000E+00 beta (00000396)=0.135247180057948E+02 gamma(00000396)=0.135247180057948E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 396 z1= 1 0.564240821923374E-07 0.000000000000000E+00 z1= 2 0.193539147409555E-06 0.000000000000000E+00 z1= 3 0.252513587264379E-02 0.000000000000000E+00 alpha(00000396)=0.000000000000000E+00 beta (00000397)=0.115567979416471E+02 gamma(00000397)=0.115567979416471E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 397 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000397)=0.000000000000000E+00 beta (00000398)=0.143072263254180E+02 gamma(00000398)=0.143072263254180E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 398 z1= 1 0.709563716064926E-07 0.000000000000000E+00 z1= 2 0.138434396755442E-06 0.000000000000000E+00 z1= 3 -.203859647516998E-02 0.000000000000000E+00 alpha(00000398)=0.000000000000000E+00 beta (00000399)=0.131449573472579E+02 gamma(00000399)=0.131449573472579E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 399 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000399)=0.000000000000000E+00 beta (00000400)=0.133574850642824E+02 gamma(00000400)=0.133574850642824E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 400 z1= 1 0.786089532746684E-08 0.000000000000000E+00 z1= 2 0.923713135679311E-07 0.000000000000000E+00 z1= 3 0.198210687883958E-02 0.000000000000000E+00 alpha(00000400)=0.000000000000000E+00 beta (00000401)=0.123682028216508E+02 gamma(00000401)=0.123682028216508E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 401 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000401)=0.000000000000000E+00 beta (00000402)=0.131994175940832E+02 gamma(00000402)=0.131994175940832E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 402 z1= 1 0.553314252870613E-07 0.000000000000000E+00 z1= 2 0.505908912674762E-07 0.000000000000000E+00 z1= 3 -.185223021376940E-02 0.000000000000000E+00 alpha(00000402)=0.000000000000000E+00 beta (00000403)=0.123723818598021E+02 gamma(00000403)=0.123723818598021E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 403 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000403)=0.000000000000000E+00 beta (00000404)=0.133989506879462E+02 gamma(00000404)=0.133989506879462E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 404 z1= 1 -.558113081436037E-07 0.000000000000000E+00 z1= 2 -.212991612201074E-07 0.000000000000000E+00 z1= 3 0.181205143793923E-02 0.000000000000000E+00 alpha(00000404)=0.000000000000000E+00 beta (00000405)=0.125316082276428E+02 gamma(00000405)=0.125316082276428E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 405 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000405)=0.000000000000000E+00 beta (00000406)=0.136810165988193E+02 gamma(00000406)=0.136810165988193E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 406 z1= 1 0.536075650100967E-07 0.000000000000000E+00 z1= 2 -.626978474119102E-08 0.000000000000000E+00 z1= 3 -.147862859195172E-02 0.000000000000000E+00 alpha(00000406)=0.000000000000000E+00 beta (00000407)=0.122939988569262E+02 gamma(00000407)=0.122939988569262E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 407 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000407)=0.000000000000000E+00 beta (00000408)=0.130807791870390E+02 gamma(00000408)=0.130807791870390E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 408 z1= 1 -.117346744309263E-06 0.000000000000000E+00 z1= 2 -.126302323305095E-06 0.000000000000000E+00 z1= 3 0.947869726504822E-03 0.000000000000000E+00 alpha(00000408)=0.000000000000000E+00 beta (00000409)=0.128433981424685E+02 gamma(00000409)=0.128433981424685E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 409 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000409)=0.000000000000000E+00 beta (00000410)=0.135152686489572E+02 gamma(00000410)=0.135152686489572E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 410 z1= 1 0.140934946950624E-07 0.000000000000000E+00 z1= 2 -.101267601014011E-06 0.000000000000000E+00 z1= 3 -.625798873830459E-03 0.000000000000000E+00 alpha(00000410)=0.000000000000000E+00 beta (00000411)=0.121510284958703E+02 gamma(00000411)=0.121510284958703E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 411 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000411)=0.000000000000000E+00 beta (00000412)=0.135035268089454E+02 gamma(00000412)=0.135035268089454E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 412 z1= 1 -.160896498287415E-06 0.000000000000000E+00 z1= 2 -.235813183545146E-06 0.000000000000000E+00 z1= 3 0.295158778887843E-03 0.000000000000000E+00 alpha(00000412)=0.000000000000000E+00 beta (00000413)=0.129411037308770E+02 gamma(00000413)=0.129411037308770E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 413 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000413)=0.000000000000000E+00 beta (00000414)=0.129803849578320E+02 gamma(00000414)=0.129803849578320E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 414 z1= 1 -.243316386964836E-07 0.000000000000000E+00 z1= 2 -.217139347623990E-06 0.000000000000000E+00 z1= 3 -.865203861318696E-04 0.000000000000000E+00 alpha(00000414)=0.000000000000000E+00 beta (00000415)=0.121119551351934E+02 gamma(00000415)=0.121119551351934E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 415 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000415)=0.000000000000000E+00 beta (00000416)=0.134062755065967E+02 gamma(00000416)=0.134062755065967E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 416 z1= 1 -.253052264495655E-06 0.000000000000000E+00 z1= 2 -.435128801979951E-06 0.000000000000000E+00 z1= 3 0.545130660207799E-05 0.000000000000000E+00 alpha(00000416)=0.000000000000000E+00 beta (00000417)=0.128940494095473E+02 gamma(00000417)=0.128940494095473E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 417 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000417)=0.000000000000000E+00 beta (00000418)=0.127840129999021E+02 gamma(00000418)=0.127840129999021E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 418 z1= 1 -.135259458759881E-06 0.000000000000000E+00 z1= 2 -.490638629667504E-06 0.000000000000000E+00 z1= 3 -.160449360096420E-03 0.000000000000000E+00 alpha(00000418)=0.000000000000000E+00 beta (00000419)=0.129272191318505E+02 gamma(00000419)=0.129272191318505E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 419 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000419)=0.000000000000000E+00 beta (00000420)=0.132043476855377E+02 gamma(00000420)=0.132043476855377E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 420 z1= 1 -.400791657529688E-06 0.000000000000000E+00 z1= 2 -.783707874720072E-06 0.000000000000000E+00 z1= 3 0.298561786908921E-03 0.000000000000000E+00 alpha(00000420)=0.000000000000000E+00 beta (00000421)=0.121787880628272E+02 gamma(00000421)=0.121787880628272E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 421 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000421)=0.000000000000000E+00 beta (00000422)=0.132591328157557E+02 gamma(00000422)=0.132591328157557E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 422 z1= 1 -.396443179513867E-06 0.000000000000000E+00 z1= 2 -.106237391678601E-05 0.000000000000000E+00 z1= 3 -.325732500203610E-03 0.000000000000000E+00 alpha(00000422)=0.000000000000000E+00 beta (00000423)=0.127900955381780E+02 gamma(00000423)=0.127900955381780E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 423 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000423)=0.000000000000000E+00 beta (00000424)=0.134489176464072E+02 gamma(00000424)=0.134489176464072E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 424 z1= 1 -.692988344935678E-06 0.000000000000000E+00 z1= 2 -.150745228137748E-05 0.000000000000000E+00 z1= 3 0.152166791213445E-03 0.000000000000000E+00 alpha(00000424)=0.000000000000000E+00 beta (00000425)=0.129684763619902E+02 gamma(00000425)=0.129684763619902E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 425 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000425)=0.000000000000000E+00 beta (00000426)=0.131645191130838E+02 gamma(00000426)=0.131645191130838E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 426 z1= 1 -.716214206155849E-06 0.000000000000000E+00 z1= 2 -.179735843209997E-05 0.000000000000000E+00 z1= 3 -.397852921207632E-04 0.000000000000000E+00 alpha(00000426)=0.000000000000000E+00 beta (00000427)=0.128863292283110E+02 gamma(00000427)=0.128863292283110E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 427 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000427)=0.000000000000000E+00 beta (00000428)=0.139198793474468E+02 gamma(00000428)=0.139198793474468E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 428 z1= 1 -.920415204343737E-06 0.000000000000000E+00 z1= 2 -.207683634161288E-05 0.000000000000000E+00 z1= 3 0.776941119794913E-04 0.000000000000000E+00 alpha(00000428)=0.000000000000000E+00 beta (00000429)=0.130158883101740E+02 gamma(00000429)=0.130158883101740E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 429 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000429)=0.000000000000000E+00 beta (00000430)=0.131841899321915E+02 gamma(00000430)=0.131841899321915E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 430 z1= 1 -.816855890773023E-06 0.000000000000000E+00 z1= 2 -.198495761444110E-05 0.000000000000000E+00 z1= 3 -.334164786352062E-03 0.000000000000000E+00 alpha(00000430)=0.000000000000000E+00 beta (00000431)=0.121732846684239E+02 gamma(00000431)=0.121732846684239E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 431 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000431)=0.000000000000000E+00 beta (00000432)=0.137480688562091E+02 gamma(00000432)=0.137480688562091E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 432 z1= 1 -.919514301259399E-06 0.000000000000000E+00 z1= 2 -.212777119129354E-05 0.000000000000000E+00 z1= 3 0.878017697061498E-03 0.000000000000000E+00 alpha(00000432)=0.000000000000000E+00 beta (00000433)=0.134444260898022E+02 gamma(00000433)=0.134444260898022E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 433 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000433)=0.000000000000000E+00 beta (00000434)=0.136623150861025E+02 gamma(00000434)=0.136623150861025E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 434 z1= 1 -.809558730481639E-06 0.000000000000000E+00 z1= 2 -.191002992581154E-05 0.000000000000000E+00 z1= 3 -.152716620204483E-02 0.000000000000000E+00 alpha(00000434)=0.000000000000000E+00 beta (00000435)=0.122268943454310E+02 gamma(00000435)=0.122268943454310E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 435 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000435)=0.000000000000000E+00 beta (00000436)=0.134333680045064E+02 gamma(00000436)=0.134333680045064E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 436 z1= 1 -.641943067751071E-06 0.000000000000000E+00 z1= 2 -.152254424634147E-05 0.000000000000000E+00 z1= 3 0.189086093981971E-02 0.000000000000000E+00 alpha(00000436)=0.000000000000000E+00 beta (00000437)=0.122403676649942E+02 gamma(00000437)=0.122403676649942E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 437 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000437)=0.000000000000000E+00 beta (00000438)=0.140836861720112E+02 gamma(00000438)=0.140836861720112E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 438 z1= 1 -.649479100866320E-06 0.000000000000000E+00 z1= 2 -.148604091263502E-05 0.000000000000000E+00 z1= 3 -.196814757700445E-02 0.000000000000000E+00 alpha(00000438)=0.000000000000000E+00 beta (00000439)=0.121580826059583E+02 gamma(00000439)=0.121580826059583E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 439 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000439)=0.000000000000000E+00 beta (00000440)=0.134353352047782E+02 gamma(00000440)=0.134353352047782E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 440 z1= 1 -.484217391403304E-06 0.000000000000000E+00 z1= 2 -.122530457300038E-05 0.000000000000000E+00 z1= 3 0.208527775970988E-02 0.000000000000000E+00 alpha(00000440)=0.000000000000000E+00 beta (00000441)=0.124915641711172E+02 gamma(00000441)=0.124915641711172E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 441 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000441)=0.000000000000000E+00 beta (00000442)=0.131805064057937E+02 gamma(00000442)=0.131805064057937E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 442 z1= 1 -.660848587985237E-06 0.000000000000000E+00 z1= 2 -.143168463434930E-05 0.000000000000000E+00 z1= 3 -.222688774919800E-02 0.000000000000000E+00 alpha(00000442)=0.000000000000000E+00 beta (00000443)=0.132768417276254E+02 gamma(00000443)=0.132768417276254E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 443 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000443)=0.000000000000000E+00 beta (00000444)=0.139856777454181E+02 gamma(00000444)=0.139856777454181E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 444 z1= 1 -.426097731882251E-06 0.000000000000000E+00 z1= 2 -.114160916869690E-05 0.000000000000000E+00 z1= 3 0.253278464615222E-02 0.000000000000000E+00 alpha(00000444)=0.000000000000000E+00 beta (00000445)=0.127416669749097E+02 gamma(00000445)=0.127416669749097E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 445 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000445)=0.000000000000000E+00 beta (00000446)=0.134297479005265E+02 gamma(00000446)=0.134297479005265E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 446 z1= 1 -.502440456859451E-06 0.000000000000000E+00 z1= 2 -.103926584160566E-05 0.000000000000000E+00 z1= 3 -.282027852868428E-02 0.000000000000000E+00 alpha(00000446)=0.000000000000000E+00 beta (00000447)=0.125106858591356E+02 gamma(00000447)=0.125106858591356E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 447 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000447)=0.000000000000000E+00 beta (00000448)=0.132875974647162E+02 gamma(00000448)=0.132875974647162E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 448 z1= 1 -.172162099749962E-06 0.000000000000000E+00 z1= 2 -.552956672267898E-06 0.000000000000000E+00 z1= 3 0.274865171532109E-02 0.000000000000000E+00 alpha(00000448)=0.000000000000000E+00 beta (00000449)=0.129365324002788E+02 gamma(00000449)=0.129365324002788E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 449 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000449)=0.000000000000000E+00 beta (00000450)=0.134615512021064E+02 gamma(00000450)=0.134615512021064E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 450 z1= 1 -.281416384556588E-06 0.000000000000000E+00 z1= 2 -.521704550447135E-06 0.000000000000000E+00 z1= 3 -.255765164115418E-02 0.000000000000000E+00 alpha(00000450)=0.000000000000000E+00 beta (00000451)=0.133705050477356E+02 gamma(00000451)=0.133705050477356E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 451 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000451)=0.000000000000000E+00 beta (00000452)=0.130926263856060E+02 gamma(00000452)=0.130926263856060E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 452 z1= 1 0.735941104584859E-07 0.000000000000000E+00 z1= 2 0.131875092170171E-07 0.000000000000000E+00 z1= 3 0.224482619294104E-02 0.000000000000000E+00 alpha(00000452)=0.000000000000000E+00 beta (00000453)=0.127525699391636E+02 gamma(00000453)=0.127525699391636E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 453 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000453)=0.000000000000000E+00 beta (00000454)=0.136482058148383E+02 gamma(00000454)=0.136482058148383E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 454 z1= 1 -.344904311951055E-07 0.000000000000000E+00 z1= 2 0.746992998947645E-07 0.000000000000000E+00 z1= 3 -.140856686040988E-02 0.000000000000000E+00 alpha(00000454)=0.000000000000000E+00 beta (00000455)=0.124634439272337E+02 gamma(00000455)=0.124634439272337E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 455 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000455)=0.000000000000000E+00 beta (00000456)=0.128304892463207E+02 gamma(00000456)=0.128304892463207E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 456 z1= 1 0.333829240058061E-06 0.000000000000000E+00 z1= 2 0.640189271850248E-06 0.000000000000000E+00 z1= 3 0.592744582733593E-03 0.000000000000000E+00 alpha(00000456)=0.000000000000000E+00 beta (00000457)=0.118271069753349E+02 gamma(00000457)=0.118271069753349E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 457 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000457)=0.000000000000000E+00 beta (00000458)=0.133153496830503E+02 gamma(00000458)=0.133153496830503E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 458 z1= 1 0.352938424849885E-06 0.000000000000000E+00 z1= 2 0.961002409912391E-06 0.000000000000000E+00 z1= 3 0.935237655838440E-04 0.000000000000000E+00 alpha(00000458)=0.000000000000000E+00 beta (00000459)=0.132199342917071E+02 gamma(00000459)=0.132199342917071E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 459 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000459)=0.000000000000000E+00 beta (00000460)=0.134258509478155E+02 gamma(00000460)=0.134258509478155E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 460 z1= 1 0.758867857539314E-06 0.000000000000000E+00 z1= 2 0.163349373157040E-05 0.000000000000000E+00 z1= 3 -.565427083987126E-03 0.000000000000000E+00 alpha(00000460)=0.000000000000000E+00 beta (00000461)=0.131465989268230E+02 gamma(00000461)=0.131465989268230E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 461 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000461)=0.000000000000000E+00 beta (00000462)=0.137417717770278E+02 gamma(00000462)=0.137417717770278E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 462 z1= 1 0.629467674107161E-06 0.000000000000000E+00 z1= 2 0.161536119304114E-05 0.000000000000000E+00 z1= 3 0.111066921222904E-02 0.000000000000000E+00 alpha(00000462)=0.000000000000000E+00 beta (00000463)=0.129205153599212E+02 gamma(00000463)=0.129205153599212E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 463 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000463)=0.000000000000000E+00 beta (00000464)=0.136814738964518E+02 gamma(00000464)=0.136814738964518E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 464 z1= 1 0.802364344202212E-06 0.000000000000000E+00 z1= 2 0.174686485462732E-05 0.000000000000000E+00 z1= 3 -.176600976482313E-02 0.000000000000000E+00 alpha(00000464)=0.000000000000000E+00 beta (00000465)=0.120978824721524E+02 gamma(00000465)=0.120978824721524E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 465 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000465)=0.000000000000000E+00 beta (00000466)=0.134785138148534E+02 gamma(00000466)=0.134785138148534E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 466 z1= 1 0.597451105450921E-06 0.000000000000000E+00 z1= 2 0.153684652739777E-05 0.000000000000000E+00 z1= 3 0.219555985582628E-02 0.000000000000000E+00 alpha(00000466)=0.000000000000000E+00 beta (00000467)=0.132068952681390E+02 gamma(00000467)=0.132068952681390E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 467 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000467)=0.000000000000000E+00 beta (00000468)=0.138399473288602E+02 gamma(00000468)=0.138399473288602E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 468 z1= 1 0.725063900887651E-06 0.000000000000000E+00 z1= 2 0.157291312297223E-05 0.000000000000000E+00 z1= 3 -.256527058339883E-02 0.000000000000000E+00 alpha(00000468)=0.000000000000000E+00 beta (00000469)=0.132716850677953E+02 gamma(00000469)=0.132716850677953E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 469 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000469)=0.000000000000000E+00 beta (00000470)=0.130995098760433E+02 gamma(00000470)=0.130995098760433E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 470 z1= 1 0.306586746501910E-06 0.000000000000000E+00 z1= 2 0.844058877275079E-06 0.000000000000000E+00 z1= 3 0.298177034738445E-02 0.000000000000000E+00 alpha(00000470)=0.000000000000000E+00 beta (00000471)=0.117216970514137E+02 gamma(00000471)=0.117216970514137E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 471 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000471)=0.000000000000000E+00 beta (00000472)=0.133214206455362E+02 gamma(00000472)=0.133214206455362E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 472 z1= 1 0.344444156998285E-06 0.000000000000000E+00 z1= 2 0.707677246019429E-06 0.000000000000000E+00 z1= 3 -.272435753495766E-02 0.000000000000000E+00 alpha(00000472)=0.000000000000000E+00 beta (00000473)=0.128515948012350E+02 gamma(00000473)=0.128515948012350E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 473 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000473)=0.000000000000000E+00 beta (00000474)=0.135326934147419E+02 gamma(00000474)=0.135326934147419E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 474 z1= 1 0.874929973245647E-07 0.000000000000000E+00 z1= 2 0.292156338012241E-06 0.000000000000000E+00 z1= 3 0.267939729014084E-02 0.000000000000000E+00 alpha(00000474)=0.000000000000000E+00 beta (00000475)=0.127362811455449E+02 gamma(00000475)=0.127362811455449E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 475 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000475)=0.000000000000000E+00 beta (00000476)=0.127423158171233E+02 gamma(00000476)=0.127423158171233E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 476 z1= 1 0.106939646218624E-06 0.000000000000000E+00 z1= 2 0.174679064631703E-06 0.000000000000000E+00 z1= 3 -.293585286241939E-02 0.000000000000000E+00 alpha(00000476)=0.000000000000000E+00 beta (00000477)=0.125189081303864E+02 gamma(00000477)=0.125189081303864E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 477 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000477)=0.000000000000000E+00 beta (00000478)=0.137327293629727E+02 gamma(00000478)=0.137327293629727E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 478 z1= 1 -.119027875542400E-06 0.000000000000000E+00 z1= 2 -.205471582143428E-06 0.000000000000000E+00 z1= 3 0.287176399807121E-02 0.000000000000000E+00 alpha(00000478)=0.000000000000000E+00 beta (00000479)=0.119949513622530E+02 gamma(00000479)=0.119949513622530E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 479 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000479)=0.000000000000000E+00 beta (00000480)=0.124375964101041E+02 gamma(00000480)=0.124375964101041E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 480 z1= 1 -.141386272850021E-06 0.000000000000000E+00 z1= 2 -.379281389533857E-06 0.000000000000000E+00 z1= 3 -.308638728860481E-02 0.000000000000000E+00 alpha(00000480)=0.000000000000000E+00 beta (00000481)=0.125405482196326E+02 gamma(00000481)=0.125405482196326E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 481 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000481)=0.000000000000000E+00 beta (00000482)=0.137288794620319E+02 gamma(00000482)=0.137288794620319E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 482 z1= 1 -.384197847798449E-06 0.000000000000000E+00 z1= 2 -.868928926218721E-06 0.000000000000000E+00 z1= 3 0.309665459148908E-02 0.000000000000000E+00 alpha(00000482)=0.000000000000000E+00 beta (00000483)=0.124372303653626E+02 gamma(00000483)=0.124372303653626E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 483 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000483)=0.000000000000000E+00 beta (00000484)=0.136557399525396E+02 gamma(00000484)=0.136557399525396E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 484 z1= 1 -.487755556404304E-06 0.000000000000000E+00 z1= 2 -.116889167527719E-05 0.000000000000000E+00 z1= 3 -.301155161177182E-02 0.000000000000000E+00 alpha(00000484)=0.000000000000000E+00 beta (00000485)=0.122591984379968E+02 gamma(00000485)=0.122591984379968E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 485 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000485)=0.000000000000000E+00 beta (00000486)=0.132895736591544E+02 gamma(00000486)=0.132895736591544E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 486 z1= 1 -.766403047532550E-06 0.000000000000000E+00 z1= 2 -.175722173536923E-05 0.000000000000000E+00 z1= 3 0.302824068521686E-02 0.000000000000000E+00 alpha(00000486)=0.000000000000000E+00 beta (00000487)=0.125697271649999E+02 gamma(00000487)=0.125697271649999E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 487 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000487)=0.000000000000000E+00 beta (00000488)=0.138800957733526E+02 gamma(00000488)=0.138800957733526E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 488 z1= 1 -.966517449338834E-06 0.000000000000000E+00 z1= 2 -.227396189936366E-05 0.000000000000000E+00 z1= 3 -.323338210266472E-02 0.000000000000000E+00 alpha(00000488)=0.000000000000000E+00 beta (00000489)=0.124483652333615E+02 gamma(00000489)=0.124483652333615E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 489 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000489)=0.000000000000000E+00 beta (00000490)=0.133793701711618E+02 gamma(00000490)=0.133793701711618E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 490 z1= 1 -.123692901781596E-05 0.000000000000000E+00 z1= 2 -.287037398561947E-05 0.000000000000000E+00 z1= 3 0.367984192455908E-02 0.000000000000000E+00 alpha(00000490)=0.000000000000000E+00 beta (00000491)=0.132987866879113E+02 gamma(00000491)=0.132987866879113E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 491 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000491)=0.000000000000000E+00 beta (00000492)=0.128312471974492E+02 gamma(00000492)=0.128312471974492E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 492 z1= 1 -.135605995140223E-05 0.000000000000000E+00 z1= 2 -.318853889601017E-05 0.000000000000000E+00 z1= 3 -.470891652742191E-02 0.000000000000000E+00 alpha(00000492)=0.000000000000000E+00 beta (00000493)=0.122426603243431E+02 gamma(00000493)=0.122426603243431E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 493 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000493)=0.000000000000000E+00 beta (00000494)=0.132558358730336E+02 gamma(00000494)=0.132558358730336E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 494 z1= 1 -.186810243429838E-05 0.000000000000000E+00 z1= 2 -.433857565077639E-05 0.000000000000000E+00 z1= 3 0.523989266474062E-02 0.000000000000000E+00 alpha(00000494)=0.000000000000000E+00 beta (00000495)=0.126176434775432E+02 gamma(00000495)=0.126176434775432E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 495 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000495)=0.000000000000000E+00 beta (00000496)=0.138926059070789E+02 gamma(00000496)=0.138926059070789E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 496 z1= 1 -.238583384386086E-05 0.000000000000000E+00 z1= 2 -.558891573687928E-05 0.000000000000000E+00 z1= 3 -.559801508502486E-02 0.000000000000000E+00 alpha(00000496)=0.000000000000000E+00 beta (00000497)=0.127218826020719E+02 gamma(00000497)=0.127218826020719E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 497 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000497)=0.000000000000000E+00 beta (00000498)=0.130500361641254E+02 gamma(00000498)=0.130500361641254E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 498 z1= 1 -.282311679369331E-05 0.000000000000000E+00 z1= 2 -.655829785387615E-05 0.000000000000000E+00 z1= 3 0.636997013766261E-02 0.000000000000000E+00 alpha(00000498)=0.000000000000000E+00 beta (00000499)=0.126219779734205E+02 gamma(00000499)=0.126219779734205E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 499 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000499)=0.000000000000000E+00 beta (00000500)=0.131169491007459E+02 gamma(00000500)=0.131169491007459E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 500 z1= 1 -.356126837004820E-05 0.000000000000000E+00 z1= 2 -.833856607056638E-05 0.000000000000000E+00 z1= 3 -.699564027057938E-02 0.000000000000000E+00 alpha(00000500)=0.000000000000000E+00 beta (00000501)=0.128139275350828E+02 gamma(00000501)=0.128139275350828E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal End of Lanczos iterations Finished linear response calculation... lr_main : 781.07s CPU 831.17s WALL ( 1 calls) lr_solve_e : 0.44s CPU 0.45s WALL ( 1 calls) one_step : 780.19s CPU 830.23s WALL ( 1500 calls) lr_apply : 778.86s CPU 828.85s WALL ( 3006 calls) lr_apply_int : 432.36s CPU 462.88s WALL ( 1503 calls) lr_bse_int : 137.65s CPU 152.02s WALL ( 3006 calls) lr_apply_no : 346.51s CPU 365.98s WALL ( 1503 calls) lr_bse_noint : 154.15s CPU 170.36s WALL ( 1503 calls) lr_apply : 778.86s CPU 828.85s WALL ( 3006 calls) h_psi : 384.18s CPU 390.19s WALL ( 3006 calls) lr_calc_dens : 149.86s CPU 164.91s WALL ( 1503 calls) lr_ortho : 0.54s CPU 0.54s WALL ( 3000 calls) interaction : 10.94s CPU 10.98s WALL ( 1503 calls) lr_dot : 0.14s CPU 0.16s WALL ( 3753 calls) US routines lr_sm1_psi : 0.07s CPU 0.07s WALL ( 3006 calls) General routines calbec : 0.19s CPU 0.19s WALL ( 4593 calls) fft : 52.90s CPU 53.94s WALL ( 15043 calls) ffts : 339.14s CPU 342.35s WALL ( 96216 calls) fftw : 125.58s CPU 126.06s WALL ( 48254 calls) interpolate : 0.27s CPU 0.24s WALL ( 1503 calls) davcio : 0.00s CPU 0.01s WALL ( 49 calls) Parallel routines EXX routines exx_grid : 0.00s CPU 0.00s WALL ( 1 calls) exxinit : 0.01s CPU 0.02s WALL ( 1 calls) vexx : 350.34s CPU 356.33s WALL ( 3006 calls) exxen2 : 0.07s CPU 0.07s WALL ( 1 calls) TDDFPT : 13m 1.08s CPU 13m51.19s WALL This run was terminated on: 19:18:50 31Jan2012 =------------------------------------------------------------------------------= JOB DONE. =------------------------------------------------------------------------------= TDDFPT/Examples/CH4-PBE0/CH4.tddfpt_pp-in0000644000175000017500000000025012341371500015624 0ustar mbamba&lr_input prefix='ch4', outdir='./out', itermax=10000 itermax0=450 extrapolation="osc" epsil=0.01 end=3.50d0 increment=0.001d0 start=0.0d0 ipol=4 / TDDFPT/Examples/CH4-PBE0/Makefile0000644000175000017500000000077512341371500014410 0ustar mbambainclude ../make.sys NAME = CH4 default : all all : check_results check_results: $(NAME).pw-out $(NAME).tddfpt-out $(NAME).tddfpt_pp-out $(check_pw) $(NAME).pw-out $(NAME).pw-ref $(check_tddfpt) $(NAME).tddfpt-out $(NAME).tddfpt-ref small_test: $(NAME).pw-out $(NAME).tddfpt-st-out @$(check_pw) $(NAME).pw-out $(NAME).pw-ref @$(check_tddfpt) $(NAME).tddfpt-st-out $(NAME).tddfpt-st-ref clean : - /bin/rm -rf $(NAME).pw-out $(NAME).tddfpt-out $(NAME).tddfpt_pp-out $(NAME).tddfpt-st-out *.plot out/* TDDFPT/Examples/CH4-PBE0/CH4.tddfpt-st-ref0000644000175000017500000001370612341371500015731 0ustar mbamba Program TDDFPT v.4.99 starts on 31Jan2012 at 19:21: 8 This program is part of the open-source Quantum ESPRESSO suite for quantum simulation of materials; please cite "P. Giannozzi et al., J. Phys.:Condens. Matter 21 395502 (2009); URL http://www.quantum-espresso.org", in publications or presentations arising from this work. More details at http://www.quantum-espresso.org/quote.php Parallel version (MPI), running on 1 processors ---------------------------------------- This is TDDFPT (Time Dependent Density Functional Perturbation Theory) Sub Version: 0.9 ---------------------------------------- Ultrasoft (Vanderbilt) Pseudopotentials Info: using nr1, nr2, nr3 values from input Info: using nr1s, nr2s, nr3s values from input IMPORTANT: XC functional enforced from input : Exchange-correlation = PBE0 ( 6 4 8 4 0) EXX-fraction = 0.25 Any further DFT definition will be discarded Please, verify this is what you really want file H.pbe-vbc.UPF: wavefunction(s) 0S renormalized G-vector sticks info -------------------- sticks: dense smooth PW G-vecs: dense smooth PW Sum 1789 1789 437 57051 57051 7123 Tot 895 895 219 IMPORTANT: XC functional enforced from input : Exchange-correlation = PBE0 ( 6 4 8 4 0) EXX-fraction = 0.25 Any further DFT definition will be discarded Please, verify this is what you really want EXX fraction changed: 0.25 EXX Screening parameter changed: 0.0000000 Subspace diagonalization in iterative solution of the eigenvalue problem: a serial algorithm will be used Lanczos linear response spectrum calculation Number of Lanczos iterations = 5 Gamma point algorithm Is it hybrid? T lr_wfcinit_spectrum: finished lr_solve_e Norm of initial Lanczos vectors= 1.469000658553140 Starting Lanczos loop 1 Lanczos iteration: 1 z1= 1 0.000000000000000E+00 0.000000000000000E+00 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal alpha(00000001)=0.000000000000000E+00 beta (00000002)=0.183408450220056E+01 gamma(00000002)=0.183408450220056E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 2 z1= 1 0.990801512106762E+00 0.000000000000000E+00 alpha(00000002)=0.000000000000000E+00 beta (00000003)=0.572337791980275E+01 gamma(00000003)=0.572337791980275E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 3 z1= 1 0.000000000000000E+00 0.000000000000000E+00 alpha(00000003)=0.000000000000000E+00 beta (00000004)=0.138861127079790E+02 gamma(00000004)=0.138861127079790E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 4 z1= 1 -.330755338053318E+00 0.000000000000000E+00 alpha(00000004)=0.000000000000000E+00 beta (00000005)=0.123143167044091E+02 gamma(00000005)=0.123143167044091E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 5 z1= 1 0.000000000000000E+00 0.000000000000000E+00 alpha(00000005)=0.000000000000000E+00 beta (00000006)=0.137542233817634E+02 gamma(00000006)=0.137542233817634E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal End of Lanczos iterations Finished linear response calculation... lr_main : 3.86s CPU 4.10s WALL ( 1 calls) lr_solve_e : 0.15s CPU 0.15s WALL ( 1 calls) one_step : 3.30s CPU 3.51s WALL ( 5 calls) lr_apply : 3.29s CPU 3.51s WALL ( 12 calls) lr_apply_int : 1.80s CPU 1.92s WALL ( 6 calls) lr_bse_int : 0.56s CPU 0.62s WALL ( 12 calls) lr_apply_no : 1.50s CPU 1.59s WALL ( 6 calls) lr_bse_noint : 0.70s CPU 0.78s WALL ( 6 calls) lr_apply : 3.29s CPU 3.51s WALL ( 12 calls) h_psi : 1.60s CPU 1.62s WALL ( 12 calls) lr_calc_dens : 0.62s CPU 0.68s WALL ( 6 calls) lr_ortho : 0.00s CPU 0.00s WALL ( 10 calls) interaction : 0.05s CPU 0.05s WALL ( 6 calls) lr_dot : 0.00s CPU 0.00s WALL ( 8 calls) US routines lr_sm1_psi : 0.00s CPU 0.00s WALL ( 12 calls) General routines calbec : 0.00s CPU 0.00s WALL ( 46 calls) fft : 0.27s CPU 0.28s WALL ( 73 calls) ffts : 1.50s CPU 1.51s WALL ( 408 calls) fftw : 0.66s CPU 0.67s WALL ( 250 calls) interpolate : 0.00s CPU 0.00s WALL ( 6 calls) davcio : 0.00s CPU 0.00s WALL ( 11 calls) Parallel routines EXX routines exx_grid : 0.00s CPU 0.00s WALL ( 1 calls) exxinit : 0.01s CPU 0.02s WALL ( 1 calls) vexx : 1.46s CPU 1.48s WALL ( 12 calls) exxen2 : 0.07s CPU 0.07s WALL ( 1 calls) TDDFPT : 3.86s CPU 4.10s WALL This run was terminated on: 19:21:12 31Jan2012 =------------------------------------------------------------------------------= JOB DONE. =------------------------------------------------------------------------------= TDDFPT/Examples/tools/0000755000175000017500000000000012341371517013045 5ustar mbambaTDDFPT/Examples/tools/check_pw.tcl0000755000175000017500000001346112341371500015334 0ustar mbamba#!/bin/sh # the next line restarts using tclsh \ exec tclsh "$0" "$@" proc ::main {argc argv} { global reference_file global output_file get_commandline $argc $argv puts -nonewline "Checking $output_file using $reference_file : " compare_bands compare_total_energy puts " \[OK\]" } ########################## #A procedure to read commandline ########################## proc ::get_commandline {argc argv} { global reference_file global output_file if { $argc < 1} { puts stderr "Usage: check_pw " exit 1 } if { $argc > 0 } { set state first foreach arg $argv { switch -- $state { first { set state second #check if the infile exists set output_file $arg if { [file exists $output_file] } { } else { puts stderr "Input file $output_file does not exits" exit 1 } } second { set state flag #check if the infile exists set reference_file $arg if { [file exists $reference_file] } { } else { puts stderr "Reference file $reference_file does not exits" exit 1 } } flag { switch -glob -- $arg { default { puts stderr "unknown flag $arg" exit 2 } } } } } } } #Compares the bands proc ::compare_bands {} { global reference_file global output_file global lc_pos set lc_pos 0 if [catch {open $reference_file r} fileId] { puts stderr "Cannot open $reference_file: $fileId" exit 1 } set reffile [read $fileId] close $fileId if [catch {open $output_file r} fileId] { puts stderr "Cannot open $output_file: $fileId" exit 1 } set outfile [read $fileId] close $fileId if {![regexp -nocase -- {End of self-consistent calculation(.*)! total energy} $outfile match bands_out_raw] } { puts stderr "Error reading bands from output file" exit 5 } #puts $bands_out_raw if {![regexp -nocase -- {End of self-consistent calculation(.*)! total energy} $reffile match bands_ref_raw] } { puts stderr "Error reading bands from reference file" exit 5 } #puts $bands_ref_raw if {![regexp -nocase -all -line -indices {End of self-consistent calculation} $bands_ref_raw lc_pos] } { set lc_pos 1 } set lc_pos [lindex $lc_pos end] set bands_ref_raw [regexp -inline -start $lc_pos {.*} $bands_ref_raw] #puts $bands_ref_raw if {![regexp -nocase -all -line -indices {End of self-consistent calculation} $bands_out_raw lc_pos] } { set lc_pos 1 } set lc_pos [lindex $lc_pos end] set bands_out_raw [regexp -inline -start $lc_pos {.*} $bands_out_raw] #puts $bands_out_raw foreach {lc_pos} [regexp -all -line -inline -indices {k =} $bands_out_raw] { set lc_pos [lindex [split $lc_pos] 1] #puts $lc_pos #puts [regexp -inline -start $lc_pos {.*} $bands_out_raw] if {![regexp -nocase -start $lc_pos -- {\s*(-?[0-9]+\.?[0-9]*)\s*(-?[0-9]+\.?[0-9]*)\s*(-?[0-9]+\.?[0-9]*)\s*\([^k]*} $bands_out_raw band_kp_out k_out_x k_out_y k_out_z] } { puts stderr "Error reading k-point from output file" exit 5 } #puts $band_kp_out if {![regexp -nocase -start $lc_pos -- {\s*(-?[0-9]+\.?[0-9]*)\s*(-?[0-9]+\.?[0-9]*)\s*(-?[0-9]+\.?[0-9]*)\s*\([^k]*} $bands_ref_raw band_kp_ref k_ref_x k_ref_y k_ref_z] } { puts stderr "Error reading k-point from reference file" exit 5 } if { [ expr {$k_out_x != $k_ref_x} ] && [ expr {$k_out_y != $k_ref_y} ] && [ expr {$k_out_z != $k_ref_z} ] } { puts "\[NOT OK\]" puts stderr "Discrepancy in read K points" exit 5 } if {![regexp -nocase -line -indices -- {bands \(ev\):} $band_kp_out lc_pos] } { puts stderr "Error reading bands for K point $k_out_x $_out_y $k_out_z" exit 5 } set lc_pos [lindex [split $lc_pos] 1] #puts $lc_pos regexp -start $lc_pos -- {-?[0-9]+\.?[0-9]*} $band_kp_ref band_ref regexp -start $lc_pos -- {-?[0-9]+\.?[0-9]*} $band_kp_out band_out if {[ expr {abs($band_ref - $band_out)} ] > 0.001 } { puts "\[NOT OK\]" puts stderr "Discrepancy in band values ref:$band_ref read:$band_out" exit 5 } } } #Compare the total energy proc ::compare_total_energy {} { global reference_file global output_file if [catch {open $reference_file r} fileId] { puts stderr "Cannot open $reference_file: $fileId" exit 1 } set reffile [read $fileId] close $fileId if [catch {open $output_file r} fileId] { puts stderr "Cannot open $output_file: $fileId" exit 1 } set outfile [read $fileId] close $fileId if {![regexp -nocase -all -- {total energy\s*=\s*(-?[0-9]+\.?[0-9]*)\s*Ry} $outfile match energy_out] } { puts stderr "Error reading total energy from output file" exit 5 } if {![regexp -nocase -all -- {total energy\s*=\s*(-?[0-9]+\.?[0-9]*)\s*Ry} $reffile match energy_ref] } { puts stderr "Error reading total energy from reference file" exit 5 } if {[ expr {abs($energy_ref - $energy_out)} ] > 0.0001 } { puts "\[NOT OK\]" puts stderr "Discrepancy in total energy: ref:$energy_ref read:$energy_out" exit 5 } } main $argc $argv TDDFPT/Examples/tools/check_tddfpt.tcl0000755000175000017500000001736712341371500016204 0ustar mbamba#!/bin/sh # the next line restarts using tclsh \ exec tclsh "$0" "$@" proc ::main {argc argv} { global reference_file global output_file get_commandline $argc $argv puts -nonewline "Checking $output_file using $reference_file : " look_for_bads compare_initial_vectors compare_chains puts " \[OK\]" } ########################## #A procedure to read commandline ########################## proc ::get_commandline {argc argv} { global reference_file global output_file if { $argc < 1} { puts stderr "Usage: check_tddfpt " exit 1 } if { $argc > 0 } { set state first foreach arg $argv { switch -- $state { first { set state second #check if the infile exists set output_file $arg if { [file exists $output_file] } { } else { puts stderr "Input file $output_file does not exits" exit 1 } } second { set state flag #check if the infile exists set reference_file $arg if { [file exists $reference_file] } { } else { puts stderr "Reference file $reference_file does not exits" exit 1 } } flag { switch -glob -- $arg { default { puts stderr "unknown flag $arg" exit 2 } } } } } } } #Compares the initial Lanczos vectors proc ::compare_initial_vectors {} { global reference_file global output_file global lc_pos global i global j global norm_ref global norm_out set lc_pos 0 set i 0 set j 0 if [catch {open $reference_file r} fileId] { puts stderr "Cannot open $reference_file: $fileId" exit 1 } set reffile [read $fileId] close $fileId if [catch {open $output_file r} fileId] { puts stderr "Cannot open $output_file: $fileId" exit 1 } set outfile [read $fileId] close $fileId foreach {lc_pos} [regexp -all -line -inline -indices {Norm of initial Lanczos vectors=\s*-?[0-9]+\.?[0-9]*} $reffile] { set lc_pos [lindex [split $lc_pos] 0] if {![regexp -nocase -start $lc_pos -- {\s*-?[0-9]+\.?[0-9]*\s*} $reffile norm_ref($i)] } { puts stderr "Error reading Initial Lanczos vector norm from reference file" exit 5 } incr i 1 } foreach {lc_pos} [regexp -all -line -inline -indices {Norm of initial Lanczos vectors=\s*-?[0-9]+\.?[0-9]*} $outfile] { set lc_pos [lindex [split $lc_pos] 0] if {![regexp -nocase -start $lc_pos -- {\s*-?[0-9]+\.?[0-9]*\s*} $outfile norm_out($j)] } { puts stderr "Error reading Initial Lanczos vector norm from output file" exit 5 } incr j 1 } if { $i != $j } { puts "\[NOT OK\]" puts stderr "Different number of norms in files" exit 5 } for {set i 0} {$i < $j} {incr i 1} { if { [ expr { abs( $norm_ref($i) - $norm_out($i) )} ] > 0.0001 } { puts "\[NOT OK\]" puts stderr "Discrepancy in initial Lanczos vector norms read:$norm_out($i) ref:$norm_ref($i)" exit 5 } } } #Compares the lanczos chains proc ::compare_chains {} { global reference_file global output_file global loop_pos global chain_pos global steps set lc_pos 0 if [catch {open $reference_file r} fileId] { puts stderr "Cannot open $reference_file: $fileId" exit 1 } set reffile [read $fileId] close $fileId if [catch {open $output_file r} fileId] { puts stderr "Cannot open $output_file: $fileId" exit 1 } set outfile [read $fileId] close $fileId #Number of Lanczos steps performed if {![regexp -nocase -- {Number of Lanczos iterations\s*=\s*([0-9]+)} $reffile match steps_ref] } { puts stderr "Error reading Number of Lanczos steps performed from reference file" exit 5 } if {![regexp -nocase -- {Number of Lanczos iterations\s*=\s*([0-9]+)} $outfile match steps_out] } { puts stderr "Error reading Number of Lanczos steps performed from output file" exit 5 } if { [ expr { $steps_ref != $steps_out } ] } { puts "\[NOT OK\]" puts stderr "Discrepancy in Lanczos steps performed" exit 5 } set steps $steps_ref #Loop on Lanczos loops foreach {loop loop_no} [regexp -all -line -inline -- {Starting Lanczos loop\s+([1-3])} $reffile] { set search "Starting Lanczos loop\\s+$loop_no" if {![regexp -indices -- $search $reffile loop_pos_ref] } { puts stderr "Error reading loop $loop_no in reference" exit 5 } set loop_pos_ref [lindex [split $loop_pos_ref] 1] if {![regexp -indices -- $search $outfile loop_pos_out] } { puts stderr "Error reading loop $loop_no in output" exit 5 } set loop_pos_out [lindex [split $loop_pos_out] 1] for {set i 2} {$i<=$steps+1} {incr i} { set search "beta\\s*\\\(0+$i\\\)=\(.*\)" if {![regexp -start $loop_pos_ref -linestop -- $search $reffile match beta_ref] } { puts stderr "Error reading beta $i in reference" exit 5 } if {![regexp -start $loop_pos_out -linestop -- $search $outfile match beta_out] } { puts stderr "Error reading beta $i in output" exit 5 } if { [ expr { abs(100*($beta_ref-$beta_out)/$beta_ref)} ] > 10 } { puts "\[NOT OK\]" puts stderr "Discrepancy in magnitude of p.q step:$i reference:$beta_ref read:$beta_out" exit 5 } set search "gamma\\s*\\\(0+$i\\\)=\(.*\)" if {![regexp -start $loop_pos_ref -linestop -- $search $reffile match gamma_ref] } { puts stderr "Error reading gamma $i in reference" exit 5 } if {![regexp -start $loop_pos_out -linestop -- $search $outfile match gamma_out] } { puts stderr "Error reading gamma $i in output" exit 5 } if { [ expr { $gamma_ref*$gamma_out } ] < 0.0} { puts "\[NOT OK\]" puts stderr "Discrepancy in direction of p.q step:$i reference:$gamma_ref read:$gamma_out" exit 5 } } } } #Looks for bad signs in the execution proc ::look_for_bads {} { global reference_file global output_file global lc_pos set lc_pos 0 if [catch {open $reference_file r} fileId] { puts stderr "Cannot open $reference_file: $fileId" exit 1 } set reffile [read $fileId] close $fileId if [catch {open $output_file r} fileId] { puts stderr "Cannot open $output_file: $fileId" exit 1 } set outfile [read $fileId] close $fileId if {[regexp -nocase -- {linter: root not converged} $reffile] } { puts "\[NOT OK\]" puts stderr "DVPSI root not converged in reference file" exit 5 } if {![regexp -nocase -- {response charge density does not sum to zero} $reffile] } { if {[regexp -nocase -- {response charge density does not sum to zero} $outfile] } { puts "\[NOT OK\]" puts stderr "Response charge leaks in output file whereas reference is normal" exit 5 } } } main $argc $argv TDDFPT/Examples/tools/check_move_cube.sh0000755000175000017500000000066512341371500016504 0ustar mbamba#!/bin/bash ############################################### #This script moves cubes files without complaint so that the makefile is not broken #OBM 2012 ################################################ if [ $# -ne 1 ] ; then echo "Usage:" echo "$0 " exit fi echo "Moving current cube files to $1" if [ ! -d $1 ] ; then mkdir $1 fi mv *.cube $1 cd $1 for file in *.cube do gzip $file done cd .. TDDFPT/Examples/tools/create_projection.sh0000755000175000017500000000613112341371500017074 0ustar mbamba#!/bin/bash ############################################### #This script reads the most intense peak position from a post processing output #and prepares a file for a second stage run giving projections #OBM 2010 ################################################ ################################################ #Prelimineries ################################################ if [ $# -ne 2 ] ; then echo "Usage:" echo "create_projection.sh " exit fi if [ ! -f $1 ] ; then echo "File $1 not found" exit fi if [ ! -f $2 ] ; then echo "File $2 not found" exit fi fprefix=`basename $1` fprefix=${fprefix%.*} fprefix2=`basename $2` fprefix2=${fprefix2%.*} if [ $fprefix != $fprefix2 ] ; then echo "WARNING: a possible mismatch of files!" fi echo "Processing $1 and $2" ################################################ #Reading the input file ################################################ prefix=`grep -i prefix $1` prefix=${prefix#*=} if [ -z $prefix ] ; then echo "Error reading prefix" exit fi outdir=`grep -i outdir $1` outdir=${outdir#*=} if [ -z $outdir ] ; then echo "Error reading outdir" exit fi restart_step=`grep -i restart_step $1` restart_step=${restart_step#*=} if [ -z $restart_step ] ; then echo "Error reading restart_step" exit fi itermax=`grep -i itermax $1` itermax=${itermax#*=} if [ -z $itermax ] ; then echo "Error reading itermax" exit fi ipol=`grep -i ipol $1` ipol=${ipol#*=} if [ -z $ipol ] ; then echo "Error reading ipol" exit fi if [ $ipol -eq 4 ] ; then npol=3 else npol=$ipol fi ############################################### #Taking a copy of the Liovillian ############################################### outdir_t=${outdir//\"/} outdir_t=${outdir_t//,/} outdir_t=${outdir_t//\'/} prefix_t=${prefix//\"/} prefix_t=${prefix_t//,/} prefix_t=${prefix_t//\'/} for pol in `jot $npol 1` do cp $outdir_t/$prefix_t.beta_gamma_z.$pol $outdir_t/$prefix_t-orig.beta_gamma_z.$pol done echo "$npol beta_gamma_z files are copied from $outdir_t/$prefix_t to $outdir_t/$prefix_t-orig" ################################################ #Reading the output file ################################################ peak_pos=`grep "Possible peak at" $2 |gawk 'BEGIN {intensity=-999999;value=0} \$7 > intensity {intensity=\$7;value=\$4} END {print value}'` echo "Maximum intensity peak is at $peak_pos Ry" epsil=`grep -i Broadening $2` epsil=${epsil#*=} epsil=${epsil%% Ry} if [ -z $epsil ] ; then echo "Error reading epsil" exit fi ############################################### #Writing the file ############################################### cat > $fprefix.tddfpt-in-s2 << EOF &lr_input prefix=$prefix outdir=$outdir restart_step=$restart_step restart=.false. / &lr_control itermax=$itermax ipol=$ipol charge_response=2 project=.true. / &lr_post beta_gamma_z_prefix='$prefix_t-orig' omeg=$peak_pos epsil=$epsil w_T_npol=$npol plot_type=3 / EOF TDDFPT/Examples/pseudo/0000755000175000017500000000000012341371517013204 5ustar mbambaTDDFPT/Examples/pseudo/Si.pbe-rrkj.UPF0000644000175000017500000042412612341371476015663 0ustar mbamba Generated using Andrea Dal Corso code (rrkj3) Author: Andrea Dal Corso Generation date: unknown Info: Si PBE 3s2 3p2 RRKJ3 0 The Pseudo was generated with a Non-Relativistic Calculation 2.50000000000E+00 Local Potential cutoff radius nl pn l occ Rcut Rcut US E pseu 3S 1 0 2.00 2.50000000000 2.60000000000 0.00000000000 3S 1 0 0.00 2.50000000000 2.60000000000 0.00000000000 3P 2 1 2.00 2.50000000000 2.70000000000 0.00000000000 3D 3 2 0.00 2.50000000000 2.50000000000 0.00000000000 0 Version Number Si Element NC Norm - Conserving pseudopotential F Nonlinear Core Correction SLA PW PBE PBE PBE Exchange-Correlation functional 4.00000000000 Z valence -7.47480832270 Total energy 0.0000000 0.0000000 Suggested cutoff for wfc and rho 2 Max angular momentum component 883 Number of points in mesh 2 3 Number of Wavefunctions, Number of Projectors Wavefunctions nl l occ 3S 0 2.00 3P 1 2.00 1.77053726905E-04 1.79729551320E-04 1.82445815642E-04 1.85203131043E-04 1.88002117930E-04 1.90843406086E-04 1.93727634813E-04 1.96655453076E-04 1.99627519645E-04 2.02644503249E-04 2.05707082721E-04 2.08815947154E-04 2.11971796056E-04 2.15175339506E-04 2.18427298316E-04 2.21728404189E-04 2.25079399889E-04 2.28481039403E-04 2.31934088115E-04 2.35439322975E-04 2.38997532677E-04 2.42609517831E-04 2.46276091150E-04 2.49998077629E-04 2.53776314730E-04 2.57611652573E-04 2.61504954124E-04 2.65457095393E-04 2.69468965628E-04 2.73541467517E-04 2.77675517391E-04 2.81872045428E-04 2.86131995864E-04 2.90456327206E-04 2.94846012447E-04 2.99302039285E-04 3.03825410344E-04 3.08417143402E-04 3.13078271619E-04 3.17809843768E-04 3.22612924472E-04 3.27488594446E-04 3.32437950735E-04 3.37462106965E-04 3.42562193593E-04 3.47739358159E-04 3.52994765549E-04 3.58329598249E-04 3.63745056621E-04 3.69242359166E-04 3.74822742799E-04 3.80487463130E-04 3.86237794746E-04 3.92075031495E-04 3.98000486780E-04 4.04015493854E-04 4.10121406118E-04 4.16319597429E-04 4.22611462406E-04 4.28998416745E-04 4.35481897537E-04 4.42063363593E-04 4.48744295772E-04 4.55526197309E-04 4.62410594164E-04 4.69399035352E-04 4.76493093304E-04 4.83694364212E-04 4.91004468393E-04 4.98425050650E-04 5.05957780647E-04 5.13604353278E-04 5.21366489056E-04 5.29245934494E-04 5.37244462500E-04 5.45363872776E-04 5.53605992224E-04 5.61972675356E-04 5.70465804711E-04 5.79087291279E-04 5.87839074930E-04 5.96723124853E-04 6.05741439997E-04 6.14896049520E-04 6.24189013248E-04 6.33622422138E-04 6.43198398745E-04 6.52919097706E-04 6.62786706219E-04 6.72803444536E-04 6.82971566467E-04 6.93293359882E-04 7.03771147228E-04 7.14407286050E-04 7.25204169526E-04 7.36164227000E-04 7.47289924530E-04 7.58583765447E-04 7.70048290910E-04 7.81686080488E-04 7.93499752732E-04 8.05491965767E-04 8.17665417893E-04 8.30022848188E-04 8.42567037125E-04 8.55300807200E-04 8.68227023565E-04 8.81348594674E-04 8.94668472934E-04 9.08189655375E-04 9.21915184320E-04 9.35848148071E-04 9.49991681603E-04 9.64348967272E-04 9.78923235526E-04 9.93717765638E-04 1.00873588644E-03 1.02398097707E-03 1.03945646774E-03 1.05516584051E-03 1.07111263003E-03 1.08730042442E-03 1.10373286599E-03 1.12041365212E-03 1.13734653604E-03 1.15453532773E-03 1.17198389474E-03 1.18969616306E-03 1.20767611805E-03 1.22592780526E-03 1.24445533139E-03 1.26326286523E-03 1.28235463854E-03 1.30173494705E-03 1.32140815142E-03 1.34137867819E-03 1.36165102083E-03 1.38222974069E-03 1.40311946808E-03 1.42432490326E-03 1.44585081756E-03 1.46770205439E-03 1.48988353037E-03 1.51240023644E-03 1.53525723893E-03 1.55845968079E-03 1.58201278265E-03 1.60592184405E-03 1.63019224465E-03 1.65482944538E-03 1.67983898971E-03 1.70522650491E-03 1.73099770326E-03 1.75715838340E-03 1.78371443159E-03 1.81067182305E-03 1.83803662331E-03 1.86581498957E-03 1.89401317206E-03 1.92263751552E-03 1.95169446052E-03 1.98119054501E-03 2.01113240574E-03 2.04152677973E-03 2.07238050587E-03 2.10370052636E-03 2.13549388835E-03 2.16776774547E-03 2.20052935948E-03 2.23378610188E-03 2.26754545558E-03 2.30181501657E-03 2.33660249564E-03 2.37191572014E-03 2.40776263568E-03 2.44415130798E-03 2.48108992462E-03 2.51858679697E-03 2.55665036198E-03 2.59528918410E-03 2.63451195723E-03 2.67432750667E-03 2.71474479108E-03 2.75577290453E-03 2.79742107850E-03 2.83969868402E-03 2.88261523372E-03 2.92618038401E-03 2.97040393723E-03 3.01529584386E-03 3.06086620479E-03 3.10712527352E-03 3.15408345855E-03 3.20175132566E-03 3.25013960033E-03 3.29925917012E-03 3.34912108714E-03 3.39973657054E-03 3.45111700900E-03 3.50327396336E-03 3.55621916913E-03 3.60996453922E-03 3.66452216657E-03 3.71990432685E-03 3.77612348131E-03 3.83319227948E-03 3.89112356208E-03 3.94993036391E-03 4.00962591672E-03 4.07022365229E-03 4.13173720535E-03 4.19418041671E-03 4.25756733635E-03 4.32191222661E-03 4.38722956536E-03 4.45353404926E-03 4.52084059712E-03 4.58916435318E-03 4.65852069058E-03 4.72892521479E-03 4.80039376712E-03 4.87294242831E-03 4.94658752210E-03 5.02134561894E-03 5.09723353974E-03 5.17426835959E-03 5.25246741165E-03 5.33184829103E-03 5.41242885877E-03 5.49422724585E-03 5.57726185723E-03 5.66155137605E-03 5.74711476782E-03 5.83397128466E-03 5.92214046966E-03 6.01164216124E-03 6.10249649767E-03 6.19472392155E-03 6.28834518446E-03 6.38338135155E-03 6.47985380639E-03 6.57778425566E-03 6.67719473415E-03 6.77810760962E-03 6.88054558789E-03 6.98453171795E-03 7.09008939712E-03 7.19724237631E-03 7.30601476540E-03 7.41643103863E-03 7.52851604013E-03 7.64229498951E-03 7.75779348750E-03 7.87503752175E-03 7.99405347267E-03 8.11486811934E-03 8.23750864558E-03 8.36200264601E-03 8.48837813231E-03 8.61666353951E-03 8.74688773236E-03 8.87908001184E-03 9.01327012179E-03 9.14948825554E-03 9.28776506274E-03 9.42813165627E-03 9.57061961920E-03 9.71526101192E-03 9.86208837935E-03 1.00111347583E-02 1.01624336848E-02 1.03160192017E-02 1.04719258665E-02 1.06301887587E-02 1.07908434883E-02 1.09539262032E-02 1.11194735977E-02 1.12875229207E-02 1.14581119839E-02 1.16312791707E-02 1.18070634444E-02 1.19855043572E-02 1.21666420590E-02 1.23505173066E-02 1.25371714726E-02 1.27266465552E-02 1.29189851869E-02 1.31142306448E-02 1.33124268600E-02 1.35136184273E-02 1.37178506158E-02 1.39251693785E-02 1.41356213631E-02 1.43492539222E-02 1.45661151239E-02 1.47862537629E-02 1.50097193715E-02 1.52365622302E-02 1.54668333797E-02 1.57005846320E-02 1.59378685820E-02 1.61787386197E-02 1.64232489419E-02 1.66714545644E-02 1.69234113344E-02 1.71791759435E-02 1.74388059395E-02 1.77023597405E-02 1.79698966471E-02 1.82414768563E-02 1.85171614747E-02 1.87970125326E-02 1.90810929976E-02 1.93694667890E-02 1.96621987921E-02 1.99593548730E-02 2.02610018928E-02 2.05672077236E-02 2.08780412629E-02 2.11935724496E-02 2.15138722794E-02 2.18390128213E-02 2.21690672332E-02 2.25041097788E-02 2.28442158440E-02 2.31894619542E-02 2.35399257911E-02 2.38956862106E-02 2.42568232604E-02 2.46234181977E-02 2.49955535079E-02 2.53733129232E-02 2.57567814409E-02 2.61460453431E-02 2.65411922159E-02 2.69423109688E-02 2.73494918554E-02 2.77628264930E-02 2.81824078837E-02 2.86083304351E-02 2.90406899815E-02 2.94795838056E-02 2.99251106605E-02 3.03773707916E-02 3.08364659592E-02 3.13024994618E-02 3.17755761588E-02 3.22558024945E-02 3.27432865218E-02 3.32381379267E-02 3.37404680529E-02 3.42503899268E-02 3.47680182829E-02 3.52934695897E-02 3.58268620761E-02 3.63683157577E-02 3.69179524637E-02 3.74758958648E-02 3.80422715005E-02 3.86172068078E-02 3.92008311496E-02 3.97932758437E-02 4.03946741928E-02 4.10051615140E-02 4.16248751696E-02 4.22539545976E-02 4.28925413437E-02 4.35407790926E-02 4.41988137004E-02 4.48667932278E-02 4.55448679730E-02 4.62331905056E-02 4.69319157011E-02 4.76412007756E-02 4.83612053213E-02 4.90920913422E-02 4.98340232908E-02 5.05871681048E-02 5.13516952451E-02 5.21277767335E-02 5.29155871916E-02 5.37153038800E-02 5.45271067383E-02 5.53511784258E-02 5.61877043619E-02 5.70368727685E-02 5.78988747122E-02 5.87739041469E-02 5.96621579579E-02 6.05638360063E-02 6.14791411732E-02 6.24082794063E-02 6.33514597655E-02 6.43088944704E-02 6.52807989479E-02 6.62673918806E-02 6.72688952560E-02 6.82855344166E-02 6.93175381106E-02 7.03651385431E-02 7.14285714286E-02 7.25080760440E-02 7.36038952824E-02 7.47162757078E-02 7.58454676104E-02 7.69917250632E-02 7.81553059789E-02 7.93364721683E-02 8.05354893985E-02 8.17526274537E-02 8.29881601949E-02 8.42423656222E-02 8.55155259373E-02 8.68079276064E-02 8.81198614255E-02 8.94516225851E-02 9.08035107372E-02 9.21758300623E-02 9.35688893381E-02 9.49830020087E-02 9.64184862554E-02 9.78756650684E-02 9.93548663188E-02 1.00856422833E-01 1.02380672469E-01 1.03927958187E-01 1.05498628134E-01 1.07093035718E-01 1.08711539687E-01 1.10354504211E-01 1.12022298964E-01 1.13715299206E-01 1.15433885871E-01 1.17178445647E-01 1.18949371068E-01 1.20747060599E-01 1.22571918727E-01 1.24424356055E-01 1.26304789388E-01 1.28213641831E-01 1.30151342885E-01 1.32118328540E-01 1.34115041376E-01 1.36141930662E-01 1.38199452457E-01 1.40288069712E-01 1.42408252375E-01 1.44560477494E-01 1.46745229332E-01 1.48962999465E-01 1.51214286901E-01 1.53499598190E-01 1.55819447536E-01 1.58174356915E-01 1.60564856191E-01 1.62991483238E-01 1.65454784056E-01 1.67955312898E-01 1.70493632395E-01 1.73070313678E-01 1.75685936511E-01 1.78341089422E-01 1.81036369830E-01 1.83772384185E-01 1.86549748102E-01 1.89369086499E-01 1.92231033739E-01 1.95136233773E-01 1.98085340283E-01 2.01079016830E-01 2.04117937005E-01 2.07202784576E-01 2.10334253648E-01 2.13513048814E-01 2.16739885317E-01 2.20015489208E-01 2.23340597513E-01 2.26715958395E-01 2.30142331323E-01 2.33620487248E-01 2.37151208767E-01 2.40735290309E-01 2.44373538306E-01 2.48066771381E-01 2.51815820526E-01 2.55621529293E-01 2.59484753982E-01 2.63406363836E-01 2.67387241233E-01 2.71428281887E-01 2.75530395050E-01 2.79694503714E-01 2.83921544821E-01 2.88212469474E-01 2.92568243148E-01 2.96989845911E-01 3.01478272643E-01 3.06034533257E-01 3.10659652933E-01 3.15354672341E-01 3.20120647881E-01 3.24958651918E-01 3.29869773021E-01 3.34855116216E-01 3.39915803224E-01 3.45052972722E-01 3.50267780595E-01 3.55561400196E-01 3.60935022612E-01 3.66389856931E-01 3.71927130513E-01 3.77548089269E-01 3.83253997937E-01 3.89046140372E-01 3.94925819830E-01 4.00894359264E-01 4.06953101619E-01 4.13103410140E-01 4.19346668670E-01 4.25684281970E-01 4.32117676029E-01 4.38648298389E-01 4.45277618466E-01 4.52007127886E-01 4.58838340816E-01 4.65772794309E-01 4.72812048646E-01 4.79957687688E-01 4.87211319235E-01 4.94574575384E-01 5.02049112899E-01 5.09636613583E-01 5.17338784654E-01 5.25157359135E-01 5.33094096237E-01 5.41150781760E-01 5.49329228491E-01 5.57631276617E-01 5.66058794132E-01 5.74613677264E-01 5.83297850898E-01 5.92113269009E-01 6.01061915103E-01 6.10145802664E-01 6.19366975605E-01 6.28727508728E-01 6.38229508193E-01 6.47875111990E-01 6.57666490420E-01 6.67605846585E-01 6.77695416883E-01 6.87937471508E-01 6.98334314966E-01 7.08888286592E-01 7.19601761072E-01 7.30477148985E-01 7.41516897338E-01 7.52723490121E-01 7.64099448865E-01 7.75647333209E-01 7.87369741474E-01 7.99269311254E-01 8.11348720000E-01 8.23610685631E-01 8.36057967141E-01 8.48693365221E-01 8.61519722889E-01 8.74539926129E-01 8.87756904541E-01 9.01173632003E-01 9.14793127333E-01 9.28618454976E-01 9.42652725690E-01 9.56899097243E-01 9.71360775131E-01 9.86041013291E-01 1.00094311484E+00 1.01607043281E+00 1.03142637091E+00 1.04701438430E+00 1.06283798035E+00 1.07890071942E+00 1.09520621571E+00 1.11175813801E+00 1.12856021059E+00 1.14561621398E+00 1.16292998584E+00 1.18050542186E+00 1.19834647658E+00 1.21645716431E+00 1.23484156004E+00 1.25350380033E+00 1.27244808426E+00 1.29167867438E+00 1.31119989764E+00 1.33101614642E+00 1.35113187945E+00 1.37155162285E+00 1.39227997115E+00 1.41332158831E+00 1.43468120880E+00 1.45636363861E+00 1.47837375638E+00 1.50071651449E+00 1.52339694014E+00 1.54642013654E+00 1.56979128398E+00 1.59351564109E+00 1.61759854594E+00 1.64204541729E+00 1.66686175578E+00 1.69205314520E+00 1.71762525372E+00 1.74358383516E+00 1.76993473033E+00 1.79668386827E+00 1.82383726767E+00 1.85140103814E+00 1.87938138166E+00 1.90778459392E+00 1.93661706576E+00 1.96588528461E+00 1.99559583595E+00 2.02575540476E+00 2.05637077709E+00 2.08744884152E+00 2.11899659074E+00 2.15102112314E+00 2.18352964436E+00 2.21652946897E+00 2.25002802205E+00 2.28403284094E+00 2.31855157685E+00 2.35359199664E+00 2.38916198457E+00 2.42526954402E+00 2.46192279935E+00 2.49912999769E+00 2.53689951083E+00 2.57523983706E+00 2.61415960312E+00 2.65366756612E+00 2.69377261551E+00 2.73448377511E+00 2.77581020510E+00 2.81776120409E+00 2.86034621123E+00 2.90357480835E+00 2.94745672204E+00 2.99200182594E+00 3.03722014286E+00 3.08312184713E+00 3.12971726683E+00 3.17701688611E+00 3.22503134759E+00 3.27377145474E+00 3.32324817427E+00 3.37347263866E+00 3.42445614863E+00 3.47621017568E+00 3.52874636468E+00 3.58207653650E+00 3.63621269066E+00 3.69116700801E+00 3.74695185351E+00 3.80357977898E+00 3.86106352595E+00 3.91941602851E+00 3.97865041620E+00 4.03878001702E+00 4.09981836039E+00 4.16177918018E+00 4.22467641785E+00 4.28852422553E+00 4.35333696926E+00 4.41912923217E+00 4.48591581780E+00 4.55371175342E+00 4.62253229339E+00 4.69239292262E+00 4.76330936007E+00 4.83529756221E+00 4.90837372670E+00 4.98255429599E+00 5.05785596102E+00 5.13429566498E+00 5.21189060712E+00 5.29065824663E+00 5.37061630657E+00 5.45178277784E+00 5.53417592323E+00 5.61781428156E+00 5.70271667179E+00 5.78890219734E+00 5.87639025030E+00 5.96520051586E+00 6.05535297670E+00 6.14686791751E+00 6.23976592953E+00 6.33406791521E+00 6.42979509289E+00 6.52696900160E+00 6.62561150587E+00 6.72574480067E+00 6.82739141643E+00 6.93057422407E+00 7.03531644014E+00 7.14164163209E+00 7.24957372354E+00 7.35913699966E+00 7.47035611265E+00 7.58325608728E+00 7.69786232653E+00 7.81420061727E+00 7.93229713612E+00 8.05217845529E+00 8.17387154858E+00 8.29740379746E+00 8.42280299719E+00 8.55009736313E+00 8.67931553705E+00 8.81048659358E+00 8.94364004677E+00 9.07880585670E+00 9.21601443624E+00 9.35529665792E+00 9.49668386081E+00 9.64020785763E+00 9.78590094189E+00 9.93379589515E+00 1.00839259944E+01 1.02363250195E+01 1.03910272610E+01 1.05480675274E+01 1.07074811535E+01 1.08693040080E+01 1.10335725018E+01 1.12003235960E+01 1.13695948102E+01 1.15414242313E+01 1.17158505214E+01 1.18929129274E+01 1.20726512889E+01 1.22551060479E+01 1.24403182575E+01 1.26283295912E+01 1.28191823523E+01 1.30129194835E+01 1.32095845765E+01 1.34092218817E+01 1.36118763185E+01 1.38175934848E+01 1.40264196680E+01 1.42384018548E+01 1.44535877420E+01 1.46720257475E+01 1.48937650206E+01 1.51188554538E+01 1.53473476932E+01 1.55792931505E+01 1.58147440146E+01 1.60537532628E+01 1.62963746731E+01 1.65426628366E+01 1.67926731689E+01 1.70464619236E+01 1.73040862041E+01 1.75656039771E+01 1.78310740850E+01 1.81005562598E+01 1.83741111361E+01 1.86518002650E+01 1.89336861276E+01 1.92198321494E+01 1.95103027146E+01 1.98051631802E+01 2.01044798911E+01 2.04083201948E+01 2.07167524566E+01 2.10298460751E+01 2.13476714976E+01 2.16703002364E+01 2.19978048841E+01 2.23302591307E+01 2.26677377798E+01 2.30103167656E+01 2.33580731697E+01 2.37110852388E+01 2.40694324021E+01 2.44331952893E+01 2.48024557485E+01 2.51772968648E+01 2.55578029792E+01 2.59440597071E+01 2.63361539578E+01 2.67341739543E+01 2.71382092527E+01 2.75483507627E+01 2.79646907678E+01 2.83873229464E+01 2.88163423923E+01 2.92518456369E+01 2.96939306701E+01 3.01426969631E+01 3.05982454899E+01 3.10606787512E+01 3.15301007961E+01 3.20066172468E+01 3.24903353214E+01 3.29813638585E+01 3.34798133416E+01 3.39857959240E+01 3.44994254538E+01 3.50208174999E+01 3.55500893776E+01 3.60873601755E+01 3.66327507816E+01 3.71863839112E+01 3.77483841341E+01 3.83188779027E+01 3.88979935804E+01 3.94858614708E+01 4.00826138466E+01 4.06883849797E+01 4.13033111710E+01 4.19275307816E+01 4.25611842634E+01 4.32044141913E+01 4.38573652947E+01 4.45201844903E+01 4.51930209152E+01 4.58760259604E+01 4.65693533051E+01 4.72731589507E+01 4.79876012565E+01 4.87128409750E+01 4.94490412883E+01 5.01963678445E+01 5.09549887952E+01 5.17250748334E+01 5.25067992316E+01 5.33003378811E+01 5.41058693316E+01 5.49235748309E+01 5.57536383662E+01 5.65962467054E+01 5.74515894389E+01 5.83198590223E+01 5.92012508201E+01 6.00959631491E+01 6.10041973233E+01 6.19261576993E+01 6.28620517220E+01 6.38120899715E+01 6.47764862105E+01 6.57554574322E+01 6.67492239092E+01 6.77580092432E+01 6.87820404151E+01 6.98215478363E+01 7.08767654004E+01 7.19479305356E+01 7.30352842588E+01 7.41390712290E+01 7.52595398030E+01 7.63969420910E+01 7.75515340133E+01 7.87235753579E+01 7.99133298390E+01 8.11210651565E+01 8.23470530560E+01 8.35915693897E+01 8.48548941792E+01 8.61373116779E+01 8.74391104351E+01 8.87605833611E+01 9.01020277927E+01 9.14637455608E+01 9.28460430574E+01 9.42492313055E+01 9.56736260282E+01 9.71195477204E+01 9.85873217205E+01 2.65580590357E-06 2.69594326980E-06 2.73668723464E-06 2.77804696565E-06 2.82003176894E-06 2.86265109129E-06 2.90591452220E-06 2.94983179614E-06 2.99441279468E-06 3.03966754873E-06 3.08560624081E-06 3.13223920730E-06 3.17957694084E-06 3.22763009259E-06 3.27640947474E-06 3.32592606284E-06 3.37619099833E-06 3.42721559105E-06 3.47901132173E-06 3.53158984463E-06 3.58496299015E-06 3.63914276746E-06 3.69414136725E-06 3.74997116444E-06 3.80664472095E-06 3.86417478859E-06 3.92257431185E-06 3.98185643089E-06 4.04203448442E-06 4.10312201276E-06 4.16513276087E-06 4.22808068142E-06 4.29197993795E-06 4.35684490809E-06 4.42269018670E-06 4.48953058927E-06 4.55738115516E-06 4.62625715104E-06 4.69617407429E-06 4.76714765652E-06 4.83919386708E-06 4.91232891669E-06 4.98656926102E-06 5.06193160447E-06 5.13843290389E-06 5.21609037239E-06 5.29492148323E-06 5.37494397374E-06 5.45617584932E-06 5.53863538749E-06 5.62234114198E-06 5.70731194695E-06 5.79356692119E-06 5.88112547242E-06 5.97000730170E-06 6.06023240781E-06 6.15182109177E-06 6.24479396144E-06 6.33917193609E-06 6.43497625117E-06 6.53222846305E-06 6.63095045390E-06 6.73116443657E-06 6.83289295964E-06 6.93615891245E-06 7.04098553028E-06 7.14739639956E-06 7.25541546318E-06 7.36506702589E-06 7.47637575975E-06 7.58936670970E-06 7.70406529917E-06 7.82049733584E-06 7.93868901741E-06 8.05866693749E-06 8.18045809164E-06 8.30408988336E-06 8.42959013034E-06 8.55698707067E-06 8.68630936918E-06 8.81758612395E-06 8.95084687280E-06 9.08612159995E-06 9.22344074280E-06 9.36283519872E-06 9.50433633207E-06 9.64797598118E-06 9.79378646560E-06 9.94180059328E-06 1.00920516680E-05 1.02445734970E-05 1.03994003982E-05 1.05565672084E-05 1.07161092908E-05 1.08780625429E-05 1.10424634050E-05 1.12093488680E-05 1.13787564817E-05 1.15507243637E-05 1.17252912073E-05 1.19024962910E-05 1.20823794865E-05 1.22649812684E-05 1.24503427228E-05 1.26385055569E-05 1.28295121080E-05 1.30234053535E-05 1.32202289201E-05 1.34200270940E-05 1.36228448306E-05 1.38287277648E-05 1.40377222211E-05 1.42498752240E-05 1.44652345091E-05 1.46838485329E-05 1.49057664846E-05 1.51310382966E-05 1.53597146561E-05 1.55918470162E-05 1.58274876076E-05 1.60666894505E-05 1.63095063663E-05 1.65559929899E-05 1.68062047817E-05 1.70601980405E-05 1.73180299159E-05 1.75797584210E-05 1.78454424460E-05 1.81151417708E-05 1.83889170789E-05 1.86668299709E-05 1.89489429784E-05 1.92353195780E-05 1.95260242057E-05 1.98211222712E-05 2.01206801729E-05 2.04247653124E-05 2.07334461104E-05 2.10467920211E-05 2.13648735489E-05 2.16877622634E-05 2.20155308158E-05 2.23482529556E-05 2.26860035466E-05 2.30288585840E-05 2.33768952118E-05 2.37301917397E-05 2.40888276608E-05 2.44528836697E-05 2.48224416807E-05 2.51975848457E-05 2.55783975737E-05 2.59649655490E-05 2.63573757510E-05 2.67557164739E-05 2.71600773458E-05 2.75705493497E-05 2.79872248435E-05 2.84101975810E-05 2.88395627327E-05 2.92754169078E-05 2.97178581752E-05 3.01669860860E-05 3.06229016960E-05 3.10857075881E-05 3.15555078955E-05 3.20324083253E-05 3.25165161821E-05 3.30079403922E-05 3.35067915282E-05 3.40131818336E-05 3.45272252485E-05 3.50490374347E-05 3.55787358021E-05 3.61164395353E-05 3.66622696196E-05 3.72163488694E-05 3.77788019546E-05 3.83497554296E-05 3.89293377614E-05 3.95176793585E-05 4.01149126001E-05 4.07211718663E-05 4.13365935679E-05 4.19613161775E-05 4.25954802602E-05 4.32392285057E-05 4.38927057601E-05 4.45560590584E-05 4.52294376580E-05 4.59129930718E-05 4.66068791028E-05 4.73112518782E-05 4.80262698849E-05 4.87520940050E-05 4.94888875518E-05 5.02368163071E-05 5.09960485581E-05 5.17667551351E-05 5.25491094504E-05 5.33432875370E-05 5.41494680884E-05 5.49678324985E-05 5.57985649028E-05 5.66418522197E-05 5.74978841922E-05 5.83668534313E-05 5.92489554586E-05 6.01443887509E-05 6.10533547843E-05 6.19760580802E-05 6.29127062506E-05 6.38635100453E-05 6.48286833992E-05 6.58084434804E-05 6.68030107389E-05 6.78126089568E-05 6.88374652977E-05 6.98778103587E-05 7.09338782219E-05 7.20059065069E-05 7.30941364246E-05 7.41988128314E-05 7.53201842842E-05 7.64585030961E-05 7.76140253938E-05 7.87870111747E-05 7.99777243655E-05 8.11864328816E-05 8.24134086877E-05 8.36589278584E-05 8.49232706408E-05 8.62067215174E-05 8.75095692700E-05 8.88321070448E-05 9.01746324185E-05 9.15374474650E-05 9.29208588233E-05 9.43251777668E-05 9.57507202733E-05 9.71978070958E-05 9.86667638349E-05 1.00157921012E-04 1.01671614144E-04 1.03208183818E-04 1.04767975769E-04 1.06351340957E-04 1.07958635645E-04 1.09590221481E-04 1.11246465579E-04 1.12927740602E-04 1.14634424843E-04 1.16366902312E-04 1.18125562826E-04 1.19910802090E-04 1.21723021790E-04 1.23562629684E-04 1.25430039690E-04 1.27325671985E-04 1.29249953093E-04 1.31203315985E-04 1.33186200178E-04 1.35199051827E-04 1.37242323833E-04 1.39316475941E-04 1.41421974844E-04 1.43559294288E-04 1.45728915179E-04 1.47931325690E-04 1.50167021374E-04 1.52436505271E-04 1.54740288025E-04 1.57078887997E-04 1.59452831381E-04 1.61862652325E-04 1.64308893048E-04 1.66792103966E-04 1.69312843810E-04 1.71871679759E-04 1.74469187561E-04 1.77105951666E-04 1.79782565357E-04 1.82499630884E-04 1.85257759598E-04 1.88057572090E-04 1.90899698328E-04 1.93784777804E-04 1.96713459673E-04 1.99686402899E-04 2.02704276409E-04 2.05767759237E-04 2.08877540678E-04 2.12034320447E-04 2.15238808832E-04 2.18491726858E-04 2.21793806444E-04 2.25145790572E-04 2.28548433453E-04 2.32002500696E-04 2.35508769480E-04 2.39068028730E-04 2.42681079296E-04 2.46348734129E-04 2.50071818466E-04 2.53851170017E-04 2.57687639152E-04 2.61582089093E-04 2.65535396108E-04 2.69548449707E-04 2.73622152844E-04 2.77757422121E-04 2.81955187989E-04 2.86216394963E-04 2.90542001835E-04 2.94932981882E-04 2.99390323094E-04 3.03915028393E-04 3.08508115854E-04 3.13170618944E-04 3.17903586744E-04 3.22708084192E-04 3.27585192320E-04 3.32536008499E-04 3.37561646682E-04 3.42663237660E-04 3.47841929313E-04 3.53098886866E-04 3.58435293159E-04 3.63852348905E-04 3.69351272965E-04 3.74933302619E-04 3.80599693848E-04 3.86351721614E-04 3.92190680147E-04 3.98117883238E-04 4.04134664532E-04 4.10242377830E-04 4.16442397395E-04 4.22736118255E-04 4.29124956526E-04 4.35610349722E-04 4.42193757085E-04 4.48876659908E-04 4.55660561874E-04 4.62546989388E-04 4.69537491927E-04 4.76633642382E-04 4.83837037417E-04 4.91149297827E-04 4.98572068901E-04 5.06107020794E-04 5.13755848902E-04 5.21520274243E-04 5.29402043846E-04 5.37402931142E-04 5.45524736365E-04 5.53769286955E-04 5.62138437971E-04 5.70634072507E-04 5.79258102117E-04 5.88012467244E-04 5.96899137656E-04 6.05920112892E-04 6.15077422710E-04 6.24373127544E-04 6.33809318964E-04 6.43388120156E-04 6.53111686389E-04 6.62982205507E-04 6.73001898417E-04 6.83173019595E-04 6.93497857584E-04 7.03978735516E-04 7.14618011634E-04 7.25418079819E-04 7.36381370133E-04 7.47510349362E-04 7.58807521573E-04 7.70275428677E-04 7.81916651003E-04 7.93733807873E-04 8.05729558199E-04 8.17906601075E-04 8.30267676387E-04 8.42815565428E-04 8.55553091528E-04 8.68483120682E-04 8.81608562203E-04 8.94932369369E-04 9.08457540094E-04 9.22187117598E-04 9.36124191094E-04 9.50271896483E-04 9.64633417057E-04 9.79211984219E-04 9.94010878209E-04 1.00903342884E-03 1.02428301625E-03 1.03976307166E-03 1.05547707815E-03 1.07142857143E-03 1.08762114066E-03 1.10405842924E-03 1.12074413562E-03 1.13768201416E-03 1.15487587595E-03 1.17232958968E-03 1.19004708252E-03 1.20803234098E-03 1.22628941180E-03 1.24482240292E-03 1.26363548433E-03 1.28273288906E-03 1.30211891410E-03 1.32179792138E-03 1.34177433878E-03 1.36205266106E-03 1.38263745094E-03 1.40353334007E-03 1.42474503013E-03 1.44627729383E-03 1.46813497603E-03 1.49032299478E-03 1.51284634250E-03 1.53571008703E-03 1.55891937281E-03 1.58247942202E-03 1.60639553578E-03 1.63067309531E-03 1.65531756316E-03 1.68033448445E-03 1.70572948809E-03 1.73150828806E-03 1.75767668470E-03 1.78424056601E-03 1.81120590898E-03 1.83857878091E-03 1.86636534083E-03 1.89457184082E-03 1.92320462747E-03 1.95227014328E-03 1.98177492810E-03 2.01172562064E-03 2.04212895993E-03 2.07299178686E-03 2.10432104568E-03 2.13612378562E-03 2.16840716242E-03 2.20117843998E-03 2.23444499197E-03 2.26821430351E-03 2.30249397284E-03 2.33729171303E-03 2.37261535372E-03 2.40847284287E-03 2.44487224857E-03 2.48182176084E-03 2.51932969347E-03 2.55740448592E-03 2.59605470516E-03 2.63528904767E-03 2.67511634133E-03 2.71554554745E-03 2.75658576277E-03 2.79824622152E-03 2.84053629748E-03 2.88346550609E-03 2.92704350660E-03 2.97128010425E-03 3.01618525245E-03 3.06176905507E-03 3.10804176864E-03 3.15501380471E-03 3.20269573221E-03 3.25109827975E-03 3.30023233813E-03 3.35010896270E-03 3.40073937592E-03 3.45213496985E-03 3.50430730871E-03 3.55726813150E-03 3.61102935463E-03 3.66560307460E-03 3.72100157072E-03 3.77723730789E-03 3.83432293939E-03 3.89227130974E-03 3.95109545754E-03 4.01080861849E-03 4.07142422831E-03 4.13295592575E-03 4.19541755571E-03 4.25882317232E-03 4.32318704211E-03 4.38852364722E-03 4.45484768867E-03 4.52217408964E-03 4.59051799886E-03 4.65989479400E-03 4.73032008512E-03 4.80180971822E-03 4.87437977876E-03 4.94804659532E-03 5.02282674324E-03 5.09873704836E-03 5.17579459083E-03 5.25401670892E-03 5.33342100294E-03 5.41402533918E-03 5.49584785396E-03 5.57890695769E-03 5.66322133903E-03 5.74880996906E-03 5.83569210559E-03 5.92388729745E-03 6.01341538896E-03 6.10429652429E-03 6.19655115210E-03 6.29020003005E-03 6.38526422955E-03 6.48176514044E-03 6.57972447583E-03 6.67916427699E-03 6.78010691829E-03 6.88257511225E-03 6.98659191464E-03 7.09218072969E-03 7.19936531532E-03 7.30816978853E-03 7.41861863076E-03 7.53073669349E-03 7.64454920374E-03 7.76008176982E-03 7.87736038703E-03 7.99641144356E-03 8.11726172640E-03 8.23993842737E-03 8.36446914925E-03 8.49088191198E-03 8.61920515896E-03 8.74946776347E-03 8.88169903513E-03 9.01592872654E-03 9.15218703996E-03 9.29050463407E-03 9.43091263092E-03 9.57344262289E-03 9.71812667985E-03 9.86499735630E-03 1.00140876988E-02 1.01654312532E-02 1.03190620726E-02 1.04750147245E-02 1.06333242989E-02 1.07940264161E-02 1.09571572348E-02 1.11227534601E-02 1.12908523518E-02 1.14614917330E-02 1.16347099981E-02 1.18105461221E-02 1.19890396688E-02 1.21702308000E-02 1.23541602845E-02 1.25408695071E-02 1.27304004783E-02 1.29227958433E-02 1.31180988919E-02 1.33163535681E-02 1.35176044800E-02 1.37218969100E-02 1.39292768246E-02 1.41397908853E-02 1.43534864587E-02 1.45704116270E-02 1.47906151994E-02 1.50141467226E-02 1.52410564921E-02 1.54713955637E-02 1.57052157646E-02 1.59425697052E-02 1.61835107913E-02 1.64280932356E-02 1.66763720702E-02 1.69284031589E-02 1.71842432096E-02 1.74439497876E-02 1.77075813279E-02 1.79751971487E-02 1.82468574647E-02 1.85226234006E-02 1.88025570049E-02 1.90867212639E-02 1.93751801156E-02 1.96679984647E-02 1.99652421963E-02 2.02669781917E-02 2.05732743427E-02 2.08841995672E-02 2.11998238247E-02 2.15202181320E-02 2.18454545792E-02 2.21756063458E-02 2.25107477174E-02 2.28509541022E-02 2.31963020480E-02 2.35468692597E-02 2.39027346164E-02 2.42639781891E-02 2.46306812593E-02 2.50029263367E-02 2.53807971780E-02 2.57643788058E-02 2.61537575275E-02 2.65490209549E-02 2.69502580241E-02 2.73575590150E-02 2.77710155721E-02 2.81907207249E-02 2.86167689088E-02 2.90492559864E-02 2.94882792692E-02 2.99339375392E-02 3.03863310714E-02 3.08455616563E-02 3.13117326228E-02 3.17849488611E-02 3.22653168471E-02 3.27529446654E-02 3.32479420345E-02 3.37504203308E-02 3.42604926141E-02 3.47782736527E-02 3.53038799496E-02 3.58374297685E-02 3.63790431603E-02 3.69288419902E-02 3.74869499654E-02 3.80534926625E-02 3.86285975559E-02 3.92123940468E-02 3.98050134918E-02 4.04065892327E-02 4.10172566267E-02 4.16371530764E-02 4.22664180613E-02 4.29051931685E-02 4.35536221252E-02 4.42118508307E-02 4.48800273890E-02 4.55583021429E-02 4.62468277070E-02 4.69457590024E-02 4.76552532916E-02 4.83754702139E-02 4.91065718211E-02 4.98487226141E-02 5.06020895799E-02 5.13668422294E-02 5.21431526352E-02 5.29311954702E-02 5.37311480475E-02 5.45431903599E-02 5.53675051201E-02 5.62042778026E-02 5.70536966847E-02 5.79159528893E-02 5.87912404276E-02 5.96797562430E-02 6.05817002553E-02 6.14972754058E-02 6.24266877027E-02 6.33701462677E-02 6.43278633830E-02 6.53000545389E-02 6.62869384825E-02 6.72887372670E-02 6.83056763012E-02 6.93379844008E-02 7.03858938394E-02 7.14496404010E-02 7.25294634331E-02 7.36256059005E-02 7.47383144399E-02 7.58678394153E-02 7.70144349746E-02 7.81783591067E-02 7.93598736995E-02 8.05592445986E-02 8.17767416676E-02 8.30126388485E-02 8.42672142233E-02 8.55407500769E-02 8.68335329601E-02 8.81458537545E-02 8.94780077379E-02 9.08302946505E-02 9.22030187626E-02 9.35964889430E-02 9.50110187282E-02 9.64469263934E-02 9.79045350240E-02 9.93841725880E-02 1.00886172010E-01 1.02410871246E-01 1.03958613361E-01 1.05529746602E-01 1.07124624481E-01 1.08743605853E-01 1.10387054995E-01 1.12055341690E-01 1.13748841309E-01 1.15467934898E-01 1.17213009259E-01 1.18984457042E-01 1.20782676829E-01 1.22608073229E-01 1.24461056962E-01 1.26342044958E-01 1.28251460447E-01 1.30189733056E-01 1.32157298904E-01 1.34154600702E-01 1.36182087850E-01 1.38240216544E-01 1.40329449869E-01 1.42450257912E-01 1.44603117864E-01 1.46788514128E-01 1.49006938427E-01 1.51258889916E-01 1.53544875293E-01 1.55865408915E-01 1.58221012911E-01 1.60612217303E-01 1.63039560121E-01 1.65503587528E-01 1.68004853940E-01 1.70543922154E-01 1.73121363469E-01 1.75737757821E-01 1.78393693911E-01 1.81089769334E-01 1.83826590719E-01 1.86604773863E-01 1.89424943868E-01 1.92287735284E-01 1.95193792252E-01 1.98143768647E-01 2.01138328226E-01 2.04178144777E-01 2.07263902272E-01 2.10396295020E-01 2.13576027821E-01 2.16803816130E-01 2.20080386212E-01 2.23406475310E-01 2.26782831807E-01 2.30210215398E-01 2.33689397258E-01 2.37221160219E-01 2.40806298941E-01 2.44445620097E-01 2.48139942549E-01 2.51890097534E-01 2.55696928854E-01 2.59561293062E-01 2.63484059656E-01 2.67466111275E-01 2.71508343897E-01 2.75611667042E-01 2.79777003975E-01 2.84005291914E-01 2.88297482242E-01 2.92654540719E-01 2.97077447703E-01 3.01567198366E-01 3.06124802921E-01 3.10751286848E-01 3.15447691126E-01 3.20215072465E-01 3.25054503546E-01 3.29967073262E-01 3.34953886961E-01 3.40016066698E-01 3.45154751484E-01 3.50371097546E-01 3.55666278582E-01 3.61041486032E-01 3.66497929340E-01 3.72036836227E-01 3.77659452973E-01 3.83367044688E-01 3.89160895606E-01 3.95042309367E-01 4.01012609315E-01 4.07073138791E-01 4.13225261441E-01 4.19470361518E-01 4.25809844196E-01 4.32245135885E-01 4.38777684554E-01 4.45408960052E-01 4.52140454446E-01 4.58973682349E-01 4.65910181267E-01 4.72951511942E-01 4.80099258702E-01 4.87355029821E-01 4.94720457877E-01 5.02197200124E-01 5.09786938859E-01 5.17491381807E-01 5.25312262498E-01 5.33251340664E-01 5.41310402632E-01 5.49491261724E-01 5.57795758669E-01 5.66225762012E-01 5.74783168540E-01 5.83469903706E-01 5.92287922062E-01 6.01239207700E-01 6.10325774695E-01 6.19549667565E-01 6.28912961723E-01 6.38417763951E-01 6.48066212870E-01 6.57860479420E-01 6.67802767354E-01 6.77895313727E-01 6.88140389406E-01 6.98540299576E-01 7.09097384260E-01 7.19814018848E-01 7.30692614626E-01 7.41735619325E-01 7.52945517667E-01 7.64324831928E-01 7.75876122500E-01 7.87601988474E-01 7.99505068217E-01 8.11588039973E-01 8.23853622463E-01 8.36304575493E-01 8.48943700581E-01 8.61773841583E-01 8.74797885335E-01 8.88018762302E-01 9.01439447236E-01 9.15062959849E-01 9.28892365489E-01 9.42930775830E-01 9.57181349573E-01 9.71647293158E-01 9.86331861483E-01 1.00123835864E+00 1.01637013865E+00 1.03173060623E+00 1.04732321755E+00 1.06315148101E+00 1.07921895803E+00 1.09552926388E+00 1.11208606843E+00 1.12889309705E+00 1.14595413137E+00 1.16327301020E+00 1.18085363037E+00 1.19869994759E+00 1.21681597735E+00 1.23520579584E+00 1.25387354085E+00 1.27282341269E+00 1.29205967517E+00 1.31158665653E+00 1.33140875042E+00 1.35153041689E+00 1.37195618341E+00 1.39269064586E+00 1.41373846958E+00 1.43510439042E+00 1.45679321581E+00 1.47880982581E+00 -1.01357660776E+01 -1.01357661680E+01 -1.01357662611E+01 -1.01357663570E+01 -1.01357664556E+01 -1.01357665575E+01 -1.01357666625E+01 -1.01357667706E+01 -1.01357668820E+01 -1.01357669968E+01 -1.01357671150E+01 -1.01357672369E+01 -1.01357673625E+01 -1.01357674920E+01 -1.01357676253E+01 -1.01357677626E+01 -1.01357679043E+01 -1.01357680503E+01 -1.01357682006E+01 -1.01357683555E+01 -1.01357685150E+01 -1.01357686798E+01 -1.01357688494E+01 -1.01357690238E+01 -1.01357692039E+01 -1.01357693896E+01 -1.01357695806E+01 -1.01357697775E+01 -1.01357699806E+01 -1.01357701898E+01 -1.01357704053E+01 -1.01357706273E+01 -1.01357708561E+01 -1.01357710919E+01 -1.01357713350E+01 -1.01357715854E+01 -1.01357718433E+01 -1.01357721092E+01 -1.01357723832E+01 -1.01357726656E+01 -1.01357729565E+01 -1.01357732562E+01 -1.01357735651E+01 -1.01357738835E+01 -1.01357742115E+01 -1.01357745495E+01 -1.01357748978E+01 -1.01357752567E+01 -1.01357756266E+01 -1.01357760076E+01 -1.01357764003E+01 -1.01357768050E+01 -1.01357772219E+01 -1.01357776516E+01 -1.01357780944E+01 -1.01357785507E+01 -1.01357790208E+01 -1.01357795053E+01 -1.01357800045E+01 -1.01357805189E+01 -1.01357810490E+01 -1.01357815952E+01 -1.01357821581E+01 -1.01357827381E+01 -1.01357833357E+01 -1.01357839516E+01 -1.01357845863E+01 -1.01357852402E+01 -1.01357859141E+01 -1.01357866084E+01 -1.01357873240E+01 -1.01357880613E+01 -1.01357888211E+01 -1.01357896040E+01 -1.01357904108E+01 -1.01357912421E+01 -1.01357920988E+01 -1.01357929815E+01 -1.01357938911E+01 -1.01357948284E+01 -1.01357957943E+01 -1.01357967896E+01 -1.01357978151E+01 -1.01357988720E+01 -1.01357999610E+01 -1.01358010831E+01 -1.01358022395E+01 -1.01358034310E+01 -1.01358046589E+01 -1.01358059241E+01 -1.01358072279E+01 -1.01358085713E+01 -1.01358099557E+01 -1.01358113822E+01 -1.01358128522E+01 -1.01358143670E+01 -1.01358159278E+01 -1.01358175362E+01 -1.01358191936E+01 -1.01358209015E+01 -1.01358226613E+01 -1.01358244748E+01 -1.01358263435E+01 -1.01358282690E+01 -1.01358302533E+01 -1.01358322979E+01 -1.01358344048E+01 -1.01358365759E+01 -1.01358388131E+01 -1.01358411184E+01 -1.01358434939E+01 -1.01358459417E+01 -1.01358484641E+01 -1.01358510633E+01 -1.01358537416E+01 -1.01358565016E+01 -1.01358593455E+01 -1.01358622761E+01 -1.01358652958E+01 -1.01358684076E+01 -1.01358716141E+01 -1.01358749182E+01 -1.01358783230E+01 -1.01358818314E+01 -1.01358854466E+01 -1.01358891720E+01 -1.01358930108E+01 -1.01358969664E+01 -1.01359010425E+01 -1.01359052428E+01 -1.01359095709E+01 -1.01359140308E+01 -1.01359186265E+01 -1.01359233622E+01 -1.01359282421E+01 -1.01359332705E+01 -1.01359384520E+01 -1.01359437913E+01 -1.01359492932E+01 -1.01359549626E+01 -1.01359608046E+01 -1.01359668245E+01 -1.01359730277E+01 -1.01359794197E+01 -1.01359860064E+01 -1.01359927936E+01 -1.01359997874E+01 -1.01360069942E+01 -1.01360144204E+01 -1.01360220727E+01 -1.01360299580E+01 -1.01360380833E+01 -1.01360464560E+01 -1.01360550837E+01 -1.01360639739E+01 -1.01360731348E+01 -1.01360825746E+01 -1.01360923019E+01 -1.01361023251E+01 -1.01361126536E+01 -1.01361232964E+01 -1.01361342633E+01 -1.01361455640E+01 -1.01361572086E+01 -1.01361692078E+01 -1.01361815722E+01 -1.01361943130E+01 -1.01362074416E+01 -1.01362209697E+01 -1.01362349097E+01 -1.01362492740E+01 -1.01362640755E+01 -1.01362793274E+01 -1.01362950436E+01 -1.01363112381E+01 -1.01363279255E+01 -1.01363451207E+01 -1.01363628393E+01 -1.01363810971E+01 -1.01363999105E+01 -1.01364192964E+01 -1.01364392723E+01 -1.01364598560E+01 -1.01432220573E+01 -1.01430423342E+01 -1.01428693533E+01 -1.01427025295E+01 -1.01425419037E+01 -1.01423869927E+01 -1.01422384871E+01 -1.01420965641E+01 -1.01419586214E+01 -1.01418276715E+01 -1.01417027377E+01 -1.01415808533E+01 -1.01414655259E+01 -1.01413548805E+01 -1.01412512296E+01 -1.01411496360E+01 -1.01410547361E+01 -1.01409643336E+01 -1.01408777026E+01 -1.01407963828E+01 -1.01407198128E+01 -1.01406482944E+01 -1.01405786975E+01 -1.01405158384E+01 -1.01404565066E+01 -1.01404017156E+01 -1.01403500713E+01 -1.01403030345E+01 -1.01402614811E+01 -1.01402215555E+01 -1.01401865013E+01 -1.01401564487E+01 -1.01401300655E+01 -1.01401062022E+01 -1.01400876392E+01 -1.01400728132E+01 -1.01400613354E+01 -1.01400541404E+01 -1.01400503765E+01 -1.01400514287E+01 -1.01400549626E+01 -1.01400636154E+01 -1.01400755279E+01 -1.01400910721E+01 -1.01401105879E+01 -1.01401348350E+01 -1.01401620847E+01 -1.01401934237E+01 -1.01402288471E+01 -1.01402686639E+01 -1.01403116574E+01 -1.01403594553E+01 -1.01404109173E+01 -1.01404673489E+01 -1.01405269952E+01 -1.01405913841E+01 -1.01406603034E+01 -1.01407329483E+01 -1.01408107260E+01 -1.01408925954E+01 -1.01409795736E+01 -1.01410702184E+01 -1.01411665520E+01 -1.01412673618E+01 -1.01413732353E+01 -1.01414838541E+01 -1.01415998422E+01 -1.01417211190E+01 -1.01418471922E+01 -1.01419791596E+01 -1.01421166708E+01 -1.01422596469E+01 -1.01424084885E+01 -1.01425633006E+01 -1.01427242642E+01 -1.01428910483E+01 -1.01430645126E+01 -1.01432442872E+01 -1.01434309629E+01 -1.01436241924E+01 -1.01438244914E+01 -1.01440319771E+01 -1.01442467484E+01 -1.01444690154E+01 -1.01446993537E+01 -1.01449370003E+01 -1.01451833383E+01 -1.01454376409E+01 -1.01457005902E+01 -1.01459725153E+01 -1.01462532608E+01 -1.01465430530E+01 -1.01468430008E+01 -1.01471520277E+01 -1.01474716500E+01 -1.01478012005E+01 -1.01481414119E+01 -1.01484926941E+01 -1.01488549828E+01 -1.01492287653E+01 -1.01496144901E+01 -1.01500122750E+01 -1.01504224422E+01 -1.01508457293E+01 -1.01512818232E+01 -1.01517317775E+01 -1.01521954176E+01 -1.01526739021E+01 -1.01531625193E+01 -1.01537100241E+01 -1.01538670081E+01 -1.01557694668E+01 -1.01548941602E+01 -1.01534074439E+01 -1.01616836600E+01 -1.01535103350E+01 -1.01567707779E+01 -1.01603498601E+01 -1.01587644693E+01 -1.01581735557E+01 -1.01611870779E+01 -1.01621254075E+01 -1.01612187654E+01 -1.01623450957E+01 -1.01632814039E+01 -1.01651571359E+01 -1.01646750241E+01 -1.01657353195E+01 -1.01670146142E+01 -1.01674883838E+01 -1.01690722355E+01 -1.01695758476E+01 -1.01706055465E+01 -1.01715533504E+01 -1.01729409358E+01 -1.01743482531E+01 -1.01717621832E+01 -1.01803106420E+01 -1.01776856834E+01 -1.01750393229E+01 -1.01819579426E+01 -1.01810559153E+01 -1.01807626378E+01 -1.01861933217E+01 -1.01836671465E+01 -1.01879916015E+01 -1.01856265164E+01 -1.01926889850E+01 -1.01880761468E+01 -1.01958775373E+01 -1.01908823445E+01 -1.02011868526E+01 -1.01940555152E+01 -1.02002784215E+01 -1.02032328167E+01 -1.02024818427E+01 -1.02052303667E+01 -1.02083240274E+01 -1.02090888250E+01 -1.02118519776E+01 -1.02138991904E+01 -1.02160624380E+01 -1.02186838542E+01 -1.02208484146E+01 -1.02223013552E+01 -1.02264564143E+01 -1.02279299362E+01 -1.02311703488E+01 -1.02332325674E+01 -1.02366696808E+01 -1.02388913177E+01 -1.02419234397E+01 -1.02449598139E+01 -1.02483895508E+01 -1.02505867120E+01 -1.02548587399E+01 -1.02573099973E+01 -1.02610639211E+01 -1.02645483892E+01 -1.02677953639E+01 -1.02715803691E+01 -1.02752669174E+01 -1.02789317119E+01 -1.02828966739E+01 -1.02867693467E+01 -1.02907712737E+01 -1.02953775695E+01 -1.02992774497E+01 -1.03029145496E+01 -1.03081189172E+01 -1.03119813547E+01 -1.03175485419E+01 -1.03215403461E+01 -1.03261318567E+01 -1.03313810892E+01 -1.03364073063E+01 -1.03409618986E+01 -1.03465429110E+01 -1.03518153465E+01 -1.03569855025E+01 -1.03624368677E+01 -1.03678262650E+01 -1.03737507813E+01 -1.03789241234E+01 -1.03853413198E+01 -1.03906702374E+01 -1.03969292433E+01 -1.04027482820E+01 -1.04090282944E+01 -1.04150105286E+01 -1.04214733581E+01 -1.04276284690E+01 -1.04341411234E+01 -1.04405892036E+01 -1.04468146832E+01 -1.04536197605E+01 -1.04602634147E+01 -1.04667037867E+01 -1.04735725238E+01 -1.04801069933E+01 -1.04869485651E+01 -1.04936038361E+01 -1.05004701628E+01 -1.05070904513E+01 -1.05139564910E+01 -1.05206205906E+01 -1.05273366117E+01 -1.05340476037E+01 -1.05406628371E+01 -1.05472450721E+01 -1.05537944554E+01 -1.05602123584E+01 -1.05666187320E+01 -1.05728760062E+01 -1.05790800360E+01 -1.05851175295E+01 -1.05910593223E+01 -1.05968678978E+01 -1.06025115133E+01 -1.06080087073E+01 -1.06133146410E+01 -1.06184553267E+01 -1.06233834731E+01 -1.06281207744E+01 -1.06326138875E+01 -1.06369092938E+01 -1.06409171705E+01 -1.06447167950E+01 -1.06482202624E+01 -1.06514667330E+01 -1.06544135863E+01 -1.06570772134E+01 -1.06594341905E+01 -1.06614723730E+01 -1.06632006950E+01 -1.06645957907E+01 -1.06656528040E+01 -1.06663790106E+01 -1.06667519828E+01 -1.06667806504E+01 -1.06664467315E+01 -1.06657699527E+01 -1.06647220507E+01 -1.06633228295E+01 -1.06615580503E+01 -1.06594396986E+01 -1.06569574255E+01 -1.06541240642E+01 -1.06509364943E+01 -1.06474000235E+01 -1.06435194047E+01 -1.06393026138E+01 -1.06347501813E+01 -1.06298746019E+01 -1.06246810881E+01 -1.06191765838E+01 -1.06133726055E+01 -1.06072750745E+01 -1.06008960904E+01 -1.05942439252E+01 -1.05873296175E+01 -1.05801631345E+01 -1.05727557444E+01 -1.05651161913E+01 -1.05572575907E+01 -1.05491892718E+01 -1.05409215080E+01 -1.05324649666E+01 -1.05238300458E+01 -1.05150260924E+01 -1.05060627191E+01 -1.04969488448E+01 -1.04876933335E+01 -1.04783037864E+01 -1.04687882123E+01 -1.04591530825E+01 -1.04494054053E+01 -1.04395499807E+01 -1.04295927630E+01 -1.04195372301E+01 -1.04093877022E+01 -1.03991465955E+01 -1.03888164122E+01 -1.03783983602E+01 -1.03678932512E+01 -1.03573010407E+01 -1.03466209780E+01 -1.03358513735E+01 -1.03249902933E+01 -1.03140345646E+01 -1.03029806832E+01 -1.02918242379E+01 -1.02805602829E+01 -1.02691831666E+01 -1.02576865774E+01 -1.02460636246E+01 -1.02343067572E+01 -1.02224079084E+01 -1.02103584088E+01 -1.01981490057E+01 -1.01857699983E+01 -1.01732110855E+01 -1.01604615562E+01 -1.01475101509E+01 -1.01343452242E+01 -1.01209546557E+01 -1.01073259028E+01 -1.00934460690E+01 -1.00793018469E+01 -1.00648795753E+01 -1.00501652830E+01 -1.00351446596E+01 -1.00198031255E+01 -1.00041258269E+01 -9.98809766512E+00 -9.97170334626E+00 -9.95492736289E+00 -9.93775407551E+00 -9.92016770715E+00 -9.90215239380E+00 -9.88369220621E+00 -9.86477120168E+00 -9.84537345350E+00 -9.82548308491E+00 -9.80508432787E+00 -9.78416154953E+00 -9.76269930500E+00 -9.74068237494E+00 -9.71809582844E+00 -9.69492504208E+00 -9.67115577109E+00 -9.64677417236E+00 -9.62176686631E+00 -9.59612095833E+00 -9.56982409180E+00 -9.54286447019E+00 -9.51523089531E+00 -9.48691278189E+00 -9.45790018309E+00 -9.42818379433E+00 -9.39775496147E+00 -9.36660567216E+00 -9.33472854271E+00 -9.30211679451E+00 -9.26876422318E+00 -9.23466515263E+00 -9.19981438609E+00 -9.16420714341E+00 -9.12783899168E+00 -9.09070576593E+00 -9.05280348324E+00 -9.01412825068E+00 -8.97467616442E+00 -8.93444320899E+00 -8.89342514857E+00 -8.85161741755E+00 -8.80901500981E+00 -8.76561236658E+00 -8.72140326406E+00 -8.67638070291E+00 -8.63053679640E+00 -8.58386266106E+00 -8.53634830727E+00 -8.48798252894E+00 -8.43875279414E+00 -8.38864513296E+00 -8.33764402359E+00 -8.28573227547E+00 -8.23289090928E+00 -8.17909903315E+00 -8.12433371693E+00 -8.06856986538E+00 -8.01178009332E+00 -7.95393460738E+00 -7.89500109971E+00 -7.83494466238E+00 -7.77372773120E+00 -7.71131007225E+00 -7.64764882487E+00 -7.58269861637E+00 -7.51641176764E+00 -7.44873860699E+00 -7.37962791094E+00 -7.30902749005E+00 -7.23688493428E+00 -7.16314852891E+00 -7.08776834663E+00 -7.01069751369E+00 -6.93189363859E+00 -6.85132038322E+00 -6.76894914438E+00 -6.68476080359E+00 -6.59874749459E+00 -6.51091432949E+00 -6.42128102084E+00 -6.32988333636E+00 -6.23677432619E+00 -6.14202527006E+00 -6.04572630392E+00 -5.94798669909E+00 -5.84893478342E+00 -5.74871751049E+00 -5.64749969744E+00 -5.54546296511E+00 -5.44280442199E+00 -5.33973513915E+00 -5.23647846213E+00 -5.13326820276E+00 -5.03034674674E+00 -4.92796310382E+00 -4.82637091843E+00 -4.72582645030E+00 -4.62658652788E+00 -4.52890647434E+00 -4.43303800607E+00 -4.33922710746E+00 -4.24771189304E+00 -4.15872047901E+00 -4.07246889811E+00 -3.98915910552E+00 -3.90897713638E+00 -3.83209148632E+00 -3.75865179404E+00 -3.68878790858E+00 -3.62260942174E+00 -3.56020573947E+00 -3.50164675502E+00 -3.44698417281E+00 -3.39625351743E+00 -3.34947686080E+00 -3.30666621012E+00 -3.26782834296E+00 -3.23296394779E+00 -3.20212993949E+00 -3.17490886033E+00 -3.15598512205E+00 -3.10586604970E+00 -3.05995737792E+00 -3.01442083039E+00 -2.96958529669E+00 -2.92540858205E+00 -2.88188474815E+00 -2.83900440105E+00 -2.79675856437E+00 -2.75513830348E+00 -2.71413476479E+00 -2.67373917486E+00 -2.63394284365E+00 -2.59473716725E+00 -2.55611363055E+00 -2.51806380973E+00 -2.48057937444E+00 -2.44365208978E+00 -2.40727381798E+00 -2.37143651980E+00 -2.33613225572E+00 -2.30135318682E+00 -2.26709157548E+00 -2.23333978584E+00 -2.20009028408E+00 -2.16733563852E+00 -2.13506851951E+00 -2.10328169926E+00 -2.07196805140E+00 -2.04112055054E+00 -2.01073227160E+00 -1.98079638916E+00 -1.95130617656E+00 -1.92225500504E+00 -1.89363634277E+00 -1.86544375377E+00 -1.83767089685E+00 -1.81031152443E+00 -1.78335948136E+00 -1.75680870375E+00 -1.73065321768E+00 -1.70488713802E+00 -1.67950466712E+00 -1.65450009360E+00 -1.62986779108E+00 -1.60560221694E+00 -1.58169791111E+00 -1.55814949481E+00 -1.53495166936E+00 -1.51209921501E+00 -1.48958698974E+00 -1.46740992809E+00 -1.44556304006E+00 -1.42404140993E+00 -1.40284019520E+00 -1.38195462546E+00 -1.36138000135E+00 -1.34111169347E+00 -1.32114514136E+00 -1.30147585243E+00 -1.28209940102E+00 -1.26301142734E+00 -1.24420763652E+00 -1.22568379762E+00 -1.20743574271E+00 -1.18945936590E+00 -1.17175062245E+00 -1.15430552781E+00 -1.13712015677E+00 -1.12019064257E+00 -1.10351317600E+00 -1.08708400457E+00 -1.07089943164E+00 -1.05495581565E+00 -1.03924956919E+00 -1.02377715832E+00 -1.00853510168E+00 -9.93519969746E-01 -9.78728384048E-01 -9.64157016419E-01 -9.49802588242E-01 -9.35661869706E-01 -9.21731679092E-01 -9.08008882043E-01 -8.94490390870E-01 -8.81173163853E-01 -8.68054204555E-01 -8.55130561151E-01 -8.42399325765E-01 -8.29857633809E-01 -8.17502663348E-01 -8.05331634456E-01 -7.93341808598E-01 -7.81530488008E-01 -7.69895015088E-01 -7.58432771802E-01 -7.47141179097E-01 -7.36017696312E-01 -7.25059820615E-01 -7.14265086437E-01 -7.03631064915E-01 -6.93155363347E-01 -6.82835624654E-01 -6.72669526852E-01 -6.62654782524E-01 -6.52789138310E-01 -6.43070374397E-01 -6.33496304022E-01 -6.24064772978E-01 -6.14773659131E-01 -6.05620871941E-01 -5.96604351992E-01 -5.87722070529E-01 -5.78972029000E-01 -5.70352258611E-01 -5.61860819876E-01 -5.53495802186E-01 -5.45255323378E-01 -5.37137529308E-01 -5.29140593440E-01 -5.21262716429E-01 -5.13502125721E-01 -5.05857075149E-01 -4.98325844546E-01 -4.90906739353E-01 -4.83598090242E-01 -4.76398252734E-01 -4.69305606786E-01 -4.62318556626E-01 -4.55435530086E-01 -4.48654978456E-01 -4.41975376085E-01 -4.35395220032E-01 -4.28913029737E-01 -4.22527346679E-01 -4.16236734053E-01 -4.10039776445E-01 -4.03935079526E-01 -3.97921269688E-01 -3.91996993811E-01 -3.86160919179E-01 -3.80411732092E-01 -3.74748139249E-01 -3.69168866318E-01 -3.63672657939E-01 -3.58258277443E-01 -3.52924506494E-01 -3.47670145126E-01 -3.42494011007E-01 -3.37394939486E-01 -3.32371783249E-01 -3.27423412066E-01 -3.22548712532E-01 -3.17746587819E-01 -3.13015957428E-01 -3.08355756949E-01 -3.03764937816E-01 -2.99242467075E-01 -2.94787327152E-01 -2.90398515621E-01 -2.86075044981E-01 -2.81815942434E-01 -2.77620249662E-01 -2.73487022617E-01 -2.69415331307E-01 -2.65404259582E-01 -2.61452904936E-01 -2.57560378297E-01 -2.53725803829E-01 -2.49948318737E-01 -2.46227073071E-01 -2.42561229536E-01 -2.38949963301E-01 -2.35392461816E-01 -2.31887924627E-01 -2.28435563200E-01 -2.25034600738E-01 -2.21684272011E-01 -2.18383823180E-01 -2.15132511631E-01 -2.11929605805E-01 -2.08774385033E-01 -2.05666139380E-01 -2.02604169475E-01 -1.99587786363E-01 -1.96616311345E-01 -1.93689075827E-01 -1.90805421168E-01 -1.87964698534E-01 -1.85166268749E-01 -1.82409502157E-01 -1.79693778472E-01 -1.77018486645E-01 -1.74383024724E-01 -1.71786799720E-01 -1.69229227470E-01 -1.66709732511E-01 -1.64227747944E-01 -1.61782715314E-01 -1.59374084477E-01 -1.57001313482E-01 -1.54663868445E-01 -1.52361223430E-01 -1.50092860333E-01 -1.47858268764E-01 -1.45656945928E-01 -1.43488396520E-01 -1.41352132606E-01 -1.39247673519E-01 -1.37174545745E-01 -1.35132282823E-01 -1.33120425235E-01 -1.31138520304E-01 -1.29186122093E-01 -1.27262791305E-01 -1.25368095182E-01 -1.23501607409E-01 -1.21662908019E-01 -1.19851583296E-01 -1.18067225685E-01 -1.16309433698E-01 -1.14577811825E-01 -1.12871970442E-01 -1.11191525729E-01 -1.09536099579E-01 -1.07905319512E-01 -1.06298818598E-01 -1.04716235367E-01 -1.03157213730E-01 -1.01621402902E-01 -1.00108457318E-01 -9.86180365590E-02 -9.71498052745E-02 -9.57034331060E-02 -9.42785946137E-02 -9.28749692030E-02 -9.14922410521E-02 -9.01300990415E-02 -8.87882366834E-02 -8.74663520531E-02 -8.61641477210E-02 -8.48813306857E-02 -8.36176123079E-02 -8.23727082456E-02 -8.11463383902E-02 1 0 Beta L 649 -6.84397978112E-02 -6.94741329638E-02 -7.05241000934E-02 -7.15899354473E-02 -7.26670351283E-02 -7.37462121935E-02 -7.49040728070E-02 -7.59988970493E-02 -7.71737591969E-02 -7.83373895327E-02 -7.95226190793E-02 -8.07092861551E-02 -8.19410675408E-02 -8.31707100998E-02 -8.44533258965E-02 -8.56848958508E-02 -8.70264908170E-02 -8.82920319073E-02 -8.96565504036E-02 -9.10017001094E-02 -9.23866559738E-02 -9.37765882772E-02 -9.52015035104E-02 -9.66332485111E-02 -9.80821711965E-02 -9.95849267762E-02 -1.01091244906E-01 -1.02604419807E-01 -1.04163984500E-01 -1.05751311263E-01 -1.07341991720E-01 -1.08952196420E-01 -1.10604391327E-01 -1.12261883238E-01 -1.13997066702E-01 -1.15686122028E-01 -1.17438293718E-01 -1.19234324096E-01 -1.21010394229E-01 -1.22868840670E-01 -1.24704094373E-01 -1.26590323288E-01 -1.28503181343E-01 -1.30432647739E-01 -1.32427465555E-01 -1.34411802238E-01 -1.36440397552E-01 -1.38518751783E-01 -1.40611078954E-01 -1.42719355939E-01 -1.44895368130E-01 -1.47083829053E-01 -1.49296540996E-01 -1.51560073348E-01 -1.53852414092E-01 -1.56171623130E-01 -1.58527584315E-01 -1.60930132926E-01 -1.63359180340E-01 -1.65830413999E-01 -1.68332016132E-01 -1.70887399787E-01 -1.73453841287E-01 -1.76084202543E-01 -1.78745513907E-01 -1.81440311924E-01 -1.84183891803E-01 -1.86975324835E-01 -1.89787589435E-01 -1.92668222210E-01 -1.95573256921E-01 -1.98540744109E-01 -2.01534499084E-01 -2.04586220874E-01 -2.07665891395E-01 -2.10806627070E-01 -2.13991595978E-01 -2.17231214134E-01 -2.20517743321E-01 -2.23843084175E-01 -2.27230344244E-01 -2.30659806691E-01 -2.34150681196E-01 -2.37688637604E-01 -2.41276571561E-01 -2.44925480017E-01 -2.48626859642E-01 -2.52386643838E-01 -2.56195819303E-01 -2.60071759171E-01 -2.63998720772E-01 -2.67990825356E-01 -2.72042698919E-01 -2.76149133943E-01 -2.80331761047E-01 -2.84564242706E-01 -2.88860682970E-01 -2.93231391527E-01 -2.97660146942E-01 -3.02163263656E-01 -3.06722776708E-01 -3.11364460167E-01 -3.16063988607E-01 -3.20845067084E-01 -3.25694607855E-01 -3.30613476214E-01 -3.35613201097E-01 -3.40679500507E-01 -3.45828890262E-01 -3.51064108454E-01 -3.56359450332E-01 -3.61751556870E-01 -3.67213781419E-01 -3.72764931014E-01 -3.78403575629E-01 -3.84120182457E-01 -3.89923122709E-01 -3.95815602994E-01 -4.01800660461E-01 -4.07871511823E-01 -4.14035438520E-01 -4.20297528542E-01 -4.26646181970E-01 -4.33096536504E-01 -4.39637738027E-01 -4.46285039965E-01 -4.53025916837E-01 -4.59870619136E-01 -4.66826945145E-01 -4.73878198294E-01 -4.81041982547E-01 -4.88310871273E-01 -4.95690415073E-01 -5.03181553528E-01 -5.10787158446E-01 -5.18505286249E-01 -5.26343940734E-01 -5.34297880734E-01 -5.42369545515E-01 -5.50568672157E-01 -5.58894340204E-01 -5.67330519056E-01 -5.75913424789E-01 -5.84613448007E-01 -5.93450341102E-01 -6.02418664044E-01 -6.11522569460E-01 -6.20765712290E-01 -6.30145057740E-01 -6.39670784693E-01 -6.49334256400E-01 -6.59152783286E-01 -6.69109595520E-01 -6.79223260681E-01 -6.89489120290E-01 -6.99909705976E-01 -7.10487353591E-01 -7.21222841744E-01 -7.32124280118E-01 -7.43190177276E-01 -7.54420615286E-01 -7.65823885609E-01 -7.77395551591E-01 -7.89143740911E-01 -8.01072820549E-01 -8.13178940788E-01 -8.25465752590E-01 -8.37943550222E-01 -8.50607284279E-01 -8.63461337556E-01 -8.76509491853E-01 -8.89757577735E-01 -9.03204203092E-01 -9.16853726214E-01 -9.30710602234E-01 -9.44776648564E-01 -9.59054648277E-01 -9.73546583636E-01 -9.88262861124E-01 -1.00319725756E+00 -1.01835796291E+00 -1.03374844570E+00 -1.04936991851E+00 -1.06560289228E+00 -1.08169664198E+00 -1.09803406470E+00 -1.11461583436E+00 -1.13145058310E+00 -1.14853883130E+00 -1.16588521725E+00 -1.18349651792E+00 -1.20136999209E+00 -1.21951698579E+00 -1.23793686865E+00 -1.25663567457E+00 -1.27561589028E+00 -1.29488627362E+00 -1.31444410896E+00 -1.33430213110E+00 -1.35445504836E+00 -1.37491823353E+00 -1.39568643726E+00 -1.41677083432E+00 -1.43817455853E+00 -1.45989864295E+00 -1.48195281208E+00 -1.50434160662E+00 -1.52706812853E+00 -1.55013774936E+00 -1.57355548578E+00 -1.59732793021E+00 -1.62146037688E+00 -1.64595620754E+00 -1.67082349691E+00 -1.69606663976E+00 -1.72169075738E+00 -1.74770257894E+00 -1.77410703124E+00 -1.80091147371E+00 -1.82811935087E+00 -1.85574086700E+00 -1.88377650212E+00 -1.91223978334E+00 -1.94113028999E+00 -1.97045775183E+00 -2.00022996882E+00 -2.03045122243E+00 -2.06112942285E+00 -2.09227126673E+00 -2.12388387450E+00 -2.15597285938E+00 -2.18854791260E+00 -2.22161506535E+00 -2.25518256089E+00 -2.28925569033E+00 -2.32384616725E+00 -2.35895694728E+00 -2.39459969718E+00 -2.43078027338E+00 -2.46750726114E+00 -2.50479046693E+00 -2.54263588076E+00 -2.58105382612E+00 -2.62005135713E+00 -2.65963890381E+00 -2.69982356518E+00 -2.74061630460E+00 -2.78202580916E+00 -2.82405990582E+00 -2.86672969756E+00 -2.91004294781E+00 -2.95401206865E+00 -2.99864510272E+00 -3.04395148006E+00 -3.08994335531E+00 -3.13662961907E+00 -3.18402100483E+00 -3.23212794713E+00 -3.28096243891E+00 -3.33053421106E+00 -3.38085401138E+00 -3.43193534590E+00 -3.48378662790E+00 -3.53642236754E+00 -3.58985184049E+00 -3.64408911262E+00 -3.69914545879E+00 -3.75503303785E+00 -3.81176489138E+00 -3.86935358166E+00 -3.92781147888E+00 -3.98715205135E+00 -4.04738909883E+00 -4.10853568483E+00 -4.17060563605E+00 -4.23361254295E+00 -4.29757080388E+00 -4.36249518911E+00 -4.42839855116E+00 -4.49529869545E+00 -4.56320710900E+00 -4.63214139634E+00 -4.70211636598E+00 -4.77314746185E+00 -4.84525051899E+00 -4.91844255937E+00 -4.99273855465E+00 -5.06815627955E+00 -5.14471154916E+00 -5.22242303156E+00 -5.30130661200E+00 -5.38137968598E+00 -5.46267367645E+00 -5.54507643871E+00 -5.62922752464E+00 -5.71382411729E+00 -5.79950011393E+00 -5.88944601376E+00 -5.97566104524E+00 -6.06674070591E+00 -6.15930235994E+00 -6.25158667051E+00 -6.34557483774E+00 -6.44217446995E+00 -6.53952959158E+00 -6.63770785879E+00 -6.73806384651E+00 -6.83985805660E+00 -6.94351896464E+00 -7.04787357731E+00 -7.15435959481E+00 -7.26252386363E+00 -7.37200135043E+00 -7.48354782040E+00 -7.59634027241E+00 -7.71102900760E+00 -7.82740017680E+00 -7.94569282676E+00 -8.06576470252E+00 -8.18593057768E+00 -8.31268627693E+00 -8.43647591322E+00 -8.56207837838E+00 -8.69385919717E+00 -8.82405168280E+00 -8.95645495602E+00 -9.09353079651E+00 -9.22885482453E+00 -9.36950852799E+00 -9.50896518668E+00 -9.65520897761E+00 -9.79771252729E+00 -9.94871925319E+00 -1.00952900753E+01 -1.02521540247E+01 -1.04019688431E+01 -1.05612813804E+01 -1.07211699108E+01 -1.08813390189E+01 -1.10458739335E+01 -1.12130556297E+01 -1.13813421405E+01 -1.15533110972E+01 -1.17273929849E+01 -1.19041196403E+01 -1.20837464505E+01 -1.22657372110E+01 -1.24499513559E+01 -1.26386533081E+01 -1.28283618072E+01 -1.30220540227E+01 -1.32177932781E+01 -1.34173688519E+01 -1.36190235668E+01 -1.38242207013E+01 -1.40324361460E+01 -1.42440010489E+01 -1.44577447063E+01 -1.46761989689E+01 -1.48964515740E+01 -1.51209461273E+01 -1.53485136466E+01 -1.55792156037E+01 -1.58137281400E+01 -1.60515838419E+01 -1.62928904867E+01 -1.65379723783E+01 -1.67865445733E+01 -1.70388485879E+01 -1.72953676475E+01 -1.75549739061E+01 -1.78181014242E+01 -1.80865184199E+01 -1.83575530673E+01 -1.86341655168E+01 -1.89132418289E+01 -1.91969478043E+01 -1.94854233381E+01 -1.97778433988E+01 -2.00739926327E+01 -2.03755010079E+01 -2.06810320608E+01 -2.09908548584E+01 -2.13054517557E+01 -2.16245081078E+01 -2.19487680053E+01 -2.22768211155E+01 -2.26110525173E+01 -2.29487903474E+01 -2.32925029542E+01 -2.36406108295E+01 -2.39942897903E+01 -2.43526655590E+01 -2.47167998492E+01 -2.50857544272E+01 -2.54604718384E+01 -2.58404750309E+01 -2.62256173971E+01 -2.66170825993E+01 -2.70139336222E+01 -2.74161797092E+01 -2.78248115867E+01 -2.82388085912E+01 -2.86591984842E+01 -2.90853337872E+01 -2.95179058406E+01 -2.99562986174E+01 -3.04013724887E+01 -3.08525113994E+01 -3.13102136411E+01 -3.17744848292E+01 -3.22452690748E+01 -3.27227681000E+01 -3.32070820954E+01 -3.36981378468E+01 -3.41962479900E+01 -3.47012680019E+01 -3.52134744738E+01 -3.57327613425E+01 -3.62593647737E+01 -3.67933196360E+01 -3.73346696004E+01 -3.78835568563E+01 -3.84399983557E+01 -3.90041533618E+01 -3.95760316267E+01 -4.01557851368E+01 -4.07434071117E+01 -4.13391041437E+01 -4.19427850407E+01 -4.25547303930E+01 -4.31748468610E+01 -4.38033258674E+01 -4.44401698677E+01 -4.50855168259E+01 -4.57394087656E+01 -4.64019110179E+01 -4.70731387968E+01 -4.77531240763E+01 -4.84419412013E+01 -4.91396931575E+01 -4.98464016276E+01 -5.05621666529E+01 -5.12870109213E+01 -5.20210564422E+01 -5.27642878121E+01 -5.35168184115E+01 -5.42786602556E+01 -5.50498950679E+01 -5.58305331121E+01 -5.66206475307E+01 -5.74202572641E+01 -5.82293998154E+01 -5.90481046054E+01 -5.98764041482E+01 -6.07142995317E+01 -6.15618234076E+01 -6.24189770739E+01 -6.32857590975E+01 -6.41621761026E+01 -6.50482068422E+01 -6.59438432869E+01 -6.68490552394E+01 -6.77638135675E+01 -6.86880762370E+01 -6.96217967509E+01 -7.05649094935E+01 -7.15173560792E+01 -7.24790533203E+01 -7.34499114736E+01 -7.44298319411E+01 -7.54187040163E+01 -7.64164017245E+01 -7.74227884124E+01 -7.84377126254E+01 -7.94610102940E+01 -8.04924987785E+01 -8.15319841028E+01 -8.25792512387E+01 -8.36340731924E+01 -8.46961974976E+01 -8.57653612780E+01 -8.68412731717E+01 -8.79236286865E+01 -8.90120955528E+01 -9.01063230654E+01 -9.12059337705E+01 -9.23105273287E+01 -9.34196768158E+01 -9.45329286060E+01 -9.56497996606E+01 -9.67697803486E+01 -9.78923275232E+01 -9.90168682266E+01 -1.00142795246E+02 -1.01269467532E+02 -1.02396208054E+02 -1.03522302392E+02 -1.04646997534E+02 -1.05769500142E+02 -1.06888975504E+02 -1.08004545410E+02 -1.09115286653E+02 -1.10220230026E+02 -1.11318357708E+02 -1.12408602554E+02 -1.13489845530E+02 -1.14560914833E+02 -1.15620583430E+02 -1.16667567653E+02 -1.17700525594E+02 -1.18718055005E+02 -1.19718691631E+02 -1.20700907693E+02 -1.21663109798E+02 -1.22603637496E+02 -1.23520761447E+02 -1.24412681757E+02 -1.25277526614E+02 -1.26113350296E+02 -1.26918132259E+02 -1.27689775289E+02 -1.28426104523E+02 -1.29124866183E+02 -1.29783726566E+02 -1.30400271223E+02 -1.30972004173E+02 -1.31496347594E+02 -1.31970641412E+02 -1.32392143342E+02 -1.32758029178E+02 -1.33065393440E+02 -1.33311250152E+02 -1.33492534311E+02 -1.33606103544E+02 -1.33648740349E+02 -1.33617154722E+02 -1.33507987584E+02 -1.33317814430E+02 -1.33043150034E+02 -1.32680453588E+02 -1.32226134803E+02 -1.31676560602E+02 -1.31028063112E+02 -1.30276948236E+02 -1.29419505470E+02 -1.28452018869E+02 -1.27370779158E+02 -1.26172097111E+02 -1.24852318440E+02 -1.23407839935E+02 -1.21835127422E+02 -1.20130735084E+02 -1.18291326797E+02 -1.16313699097E+02 -1.14194806130E+02 -1.11931786684E+02 -1.09521993165E+02 -1.06963022917E+02 -1.04252751648E+02 -1.01389369233E+02 -9.83714178809E+01 -9.51978326517E+01 -9.18679844606E+01 -8.83817254305E+01 -8.47394366004E+01 -8.09420781684E+01 -7.69912416887E+01 -7.28892045523E+01 -6.86389863775E+01 -6.42444071127E+01 -5.97101464112E+01 -5.50418043234E+01 -5.02459622599E+01 -4.53302443965E+01 -4.03033782573E+01 -3.51752542325E+01 -2.99569829638E+01 -2.46609496560E+01 -1.93008641572E+01 -1.38918058451E+01 -8.45026142200E+00 -2.99415452974E+00 2.45713488510E+00 7.88276332451E+00 1.32604305045E+01 1.85664028209E+01 2.37755555716E+01 2.88614368760E+01 3.37963558502E+01 3.85514980083E+01 4.30970709470E+01 4.74024830410E+01 5.14365583568E+01 5.51677904972E+01 5.85646378884E+01 6.15958630051E+01 6.42309170034E+01 6.64403711569E+01 6.81963951035E+01 6.94732814718E+01 7.02480142858E+01 7.05008779591E+01 7.02161010562E+01 6.93825273083E+01 6.79943036245E+01 6.60515724091E+01 6.35611522758E+01 6.05371881059E+01 5.70017480853E+01 5.29853420444E+01 4.85273318081E+01 4.36762016773E+01 3.84896541410E+01 3.30344943247E+01 2.73862656810E+01 2.16285997788E+01 1.58522452527E+01 1.01537446964E+01 4.63373497762E+00 -6.05145013848E-01 -5.46074310749E+00 -9.83426836059E+00 -1.36335227466E+01 -1.67764406973E+01 -1.91948637144E+01 -2.08384519376E+01 -2.16786075159E+01 -2.17122575631E+01 -2.09653180084E+01 -1.94956357911E+01 -1.73951866114E+01 -1.47912922567E+01 -1.18466091610E+01 -8.75769534043E+00 -5.75157171408E+00 -3.08276157297E+00 -1.01279121315E+00 1.33345109890E-01 -1.64923413415E-02 1.95996148394E-03 -2.26567041800E-04 2.56764564756E-05 -2.86320258506E-06 3.15304843067E-07 -3.39835879597E-08 3.23718265038E-09 2.43242617962E-10 -8.17502230631E-10 2 0 Beta L 649 3.09860428080E-02 3.14543369050E-02 3.19297083622E-02 3.24122641404E-02 3.28999458722E-02 3.33886587682E-02 3.39126230781E-02 3.44085229250E-02 3.49402825576E-02 3.54671338109E-02 3.60037294842E-02 3.65410883689E-02 3.70987020533E-02 3.76554719547E-02 3.82360226303E-02 3.87938854353E-02 3.94010078796E-02 3.99742805931E-02 4.05918833737E-02 4.12009567387E-02 4.18279439072E-02 4.24572627205E-02 4.31023486331E-02 4.37506132732E-02 4.44066825646E-02 4.50869273308E-02 4.57689056347E-02 4.64540810744E-02 4.71601157714E-02 4.78787055444E-02 4.85989181378E-02 4.93280199371E-02 5.00760071310E-02 5.08265245837E-02 5.16118965699E-02 5.23768099579E-02 5.31700884089E-02 5.39831083267E-02 5.47873741561E-02 5.56286080751E-02 5.64596467607E-02 5.73136234830E-02 5.81796716472E-02 5.90533125441E-02 5.99563190601E-02 6.08548339577E-02 6.17732934463E-02 6.27141654107E-02 6.36614714715E-02 6.46160930554E-02 6.56011648745E-02 6.65919978381E-02 6.75938586040E-02 6.86186275747E-02 6.96564729073E-02 7.07065268967E-02 7.17732140231E-02 7.28609236159E-02 7.39606873156E-02 7.50795271336E-02 7.62121461005E-02 7.73690293455E-02 7.85310783346E-02 7.97219164148E-02 8.09268237647E-02 8.21469349267E-02 8.33890716445E-02 8.46528468625E-02 8.59261765894E-02 8.72303052142E-02 8.85455991046E-02 8.98890536982E-02 9.12445091982E-02 9.26261425435E-02 9.40205318596E-02 9.54424821965E-02 9.68844824432E-02 9.83511801820E-02 9.98391329484E-02 1.01344718682E-01 1.02878272520E-01 1.04430987499E-01 1.06011444462E-01 1.07613257349E-01 1.09237714709E-01 1.10889740776E-01 1.12565537065E-01 1.14267761864E-01 1.15992392772E-01 1.17747195449E-01 1.19525145125E-01 1.21332550620E-01 1.23167023473E-01 1.25026237552E-01 1.26919860735E-01 1.28836137350E-01 1.30781371850E-01 1.32760172460E-01 1.34765306363E-01 1.36804058472E-01 1.38868415748E-01 1.40969896943E-01 1.43097639645E-01 1.45262242691E-01 1.47457860808E-01 1.49684894875E-01 1.51948494684E-01 1.54242291442E-01 1.56573668238E-01 1.58943855269E-01 1.61341377503E-01 1.63782610464E-01 1.66255656121E-01 1.68768924378E-01 1.71321782883E-01 1.73909986247E-01 1.76537272833E-01 1.79205090659E-01 1.81914800704E-01 1.84663379927E-01 1.87454093875E-01 1.90289219049E-01 1.93163584457E-01 1.96083960658E-01 1.99045506854E-01 2.02055048539E-01 2.05106997264E-01 2.08205938055E-01 2.11355370239E-01 2.14547841837E-01 2.17791224483E-01 2.21082212963E-01 2.24423294486E-01 2.27814901217E-01 2.31258324807E-01 2.34752707367E-01 2.38301633425E-01 2.41902776889E-01 2.45557232745E-01 2.49269365415E-01 2.53038773024E-01 2.56858306237E-01 2.60744155395E-01 2.64683102836E-01 2.68683987470E-01 2.72744389056E-01 2.76866175680E-01 2.81050989807E-01 2.85297492988E-01 2.89610241842E-01 2.93985390952E-01 2.98430688677E-01 3.02938654479E-01 3.07517596323E-01 3.12165450092E-01 3.16883355227E-01 3.21672375598E-01 3.26532869436E-01 3.31468473810E-01 3.36478538955E-01 3.41563116730E-01 3.46725924733E-01 3.51964997271E-01 3.57283980849E-01 3.62684842723E-01 3.68165878682E-01 3.73728736181E-01 3.79378031042E-01 3.85111523004E-01 3.90931189834E-01 3.96838735675E-01 4.02836783550E-01 4.08924730707E-01 4.15104541712E-01 4.21378225343E-01 4.27746610938E-01 4.34210963331E-01 4.40772184538E-01 4.47434946070E-01 4.54196484651E-01 4.61060482117E-01 4.68028506763E-01 4.75101121386E-01 4.82451470468E-01 4.89737881730E-01 4.97134613481E-01 5.04641990118E-01 5.12263889335E-01 5.20000566823E-01 5.27854118061E-01 5.35827593597E-01 5.43919792638E-01 5.52135808271E-01 5.60475383779E-01 5.68941238574E-01 5.77534509331E-01 5.86259134587E-01 5.95113927892E-01 6.04104602293E-01 6.13228823655E-01 6.22493484784E-01 6.31896268899E-01 6.41442196389E-01 6.51132695451E-01 6.60968257571E-01 6.70953254245E-01 6.81089746102E-01 6.91379148298E-01 7.01823891132E-01 7.12426246029E-01 7.23189191188E-01 7.34115124887E-01 7.45205586521E-01 7.56464219959E-01 7.67893022177E-01 7.79494312964E-01 7.91271134626E-01 8.03225723056E-01 8.15361402200E-01 8.27679745993E-01 8.40185350407E-01 8.52878467373E-01 8.65765178262E-01 8.78845332526E-01 8.92123316921E-01 9.05602655012E-01 9.19285299829E-01 9.33174826137E-01 9.47274267360E-01 9.61586846010E-01 9.76115112630E-01 9.90863440225E-01 1.00583456731E+00 1.02103222059E+00 1.03645880990E+00 1.05211961352E+00 1.06801599954E+00 1.08415322636E+00 1.10053395879E+00 1.11716208187E+00 1.13404202481E+00 1.15117651520E+00 1.16857021528E+00 1.18622632924E+00 1.20414956750E+00 1.22234315737E+00 1.24081204939E+00 1.25956017967E+00 1.27859110111E+00 1.29790983054E+00 1.31751989411E+00 1.33742689445E+00 1.35763448480E+00 1.37814693852E+00 1.39896974549E+00 1.42010694102E+00 1.44156338218E+00 1.46334379557E+00 1.48545360253E+00 1.50789721774E+00 1.53067950862E+00 1.55380657724E+00 1.57728225099E+00 1.60111308213E+00 1.62530328594E+00 1.64985921791E+00 1.67478598865E+00 1.70008910431E+00 1.72577446601E+00 1.75184776329E+00 1.77831459941E+00 1.80518107071E+00 1.83245342238E+00 1.86013757088E+00 1.88823977620E+00 1.91676619437E+00 1.94572334118E+00 1.97511790317E+00 2.00495570847E+00 2.03524480070E+00 2.06599040260E+00 2.09720046959E+00 2.12888171069E+00 2.16104112018E+00 2.19368586735E+00 2.22682365408E+00 2.26046126851E+00 2.29460675007E+00 2.32926726717E+00 2.36445126173E+00 2.40016593712E+00 2.43641915874E+00 2.47322518787E+00 2.51053294967E+00 2.54863347350E+00 2.58693375753E+00 2.62572227527E+00 2.66645106343E+00 2.70547869567E+00 2.74671717995E+00 2.78862694067E+00 2.83040720613E+00 2.87295961319E+00 2.91669721407E+00 2.96077523214E+00 3.00522442208E+00 3.05066122515E+00 3.09674903569E+00 3.14368280260E+00 3.19092861626E+00 3.23914075157E+00 3.28811292244E+00 3.33767892584E+00 3.38818267919E+00 3.43924955362E+00 3.49117546011E+00 3.54386301113E+00 3.59742094650E+00 3.65178445542E+00 3.70618648168E+00 3.76358341219E+00 3.81962600109E+00 3.87648921044E+00 3.93615985886E+00 3.99510301903E+00 4.05504771893E+00 4.11711433177E+00 4.17837884234E+00 4.24206419738E+00 4.30519980266E+00 4.37141944436E+00 4.43593170049E+00 4.50430887770E+00 4.57066189909E+00 4.64169435841E+00 4.70951314188E+00 4.78164919288E+00 4.85404186235E+00 4.92655661260E+00 5.00105268749E+00 5.07674762238E+00 5.15293953135E+00 5.23080149889E+00 5.30961909962E+00 5.38963430750E+00 5.47096326618E+00 5.55336184905E+00 5.63676598295E+00 5.72220620481E+00 5.80809797140E+00 5.89579621099E+00 5.98441937856E+00 6.07478174201E+00 6.16608345734E+00 6.25899040936E+00 6.35326396913E+00 6.44905475167E+00 6.54582982378E+00 6.64474143019E+00 6.74446398301E+00 6.84610955982E+00 6.94914600993E+00 7.05360120236E+00 7.15978277193E+00 7.26747787253E+00 7.37673545082E+00 7.48770299848E+00 7.60025071804E+00 7.71448842289E+00 7.83063593494E+00 7.94817981373E+00 8.06731750147E+00 8.18885367619E+00 8.31157215844E+00 8.43682012652E+00 8.56318017054E+00 8.69163792270E+00 8.82225693981E+00 8.95466159071E+00 9.08875373683E+00 9.22527513449E+00 9.36361736865E+00 9.50390278916E+00 9.64635080931E+00 9.79081810007E+00 9.93764320737E+00 1.00861840950E+01 1.02375262101E+01 1.03904533233E+01 1.05460887847E+01 1.07037135527E+01 1.08638626770E+01 1.10261381060E+01 1.11910229543E+01 1.13580900587E+01 1.15277682993E+01 1.16998404192E+01 1.18742395671E+01 1.20515043721E+01 1.22312082258E+01 1.24133552116E+01 1.25983961533E+01 1.27858663638E+01 1.29762335283E+01 1.31692028199E+01 1.33650888035E+01 1.35636109708E+01 1.37651608288E+01 1.39694578585E+01 1.41767287678E+01 1.43869760097E+01 1.46001740481E+01 1.48164146067E+01 1.50357432009E+01 1.52581264172E+01 1.54837064783E+01 1.57124175227E+01 1.59443853765E+01 1.61795616942E+01 1.64180539116E+01 1.66598778448E+01 1.69050533218E+01 1.71536450237E+01 1.74056606302E+01 1.76611726088E+01 1.79201853787E+01 1.81827681127E+01 1.84489177222E+01 1.87187282553E+01 1.89921582205E+01 1.92693353722E+01 1.95502172632E+01 1.98348910836E+01 2.01233580178E+01 2.04156809487E+01 2.07118791010E+01 2.10119823252E+01 2.13160431951E+01 2.16240764100E+01 2.19361159750E+01 2.22522089533E+01 2.25723654161E+01 2.28966311279E+01 2.32250166612E+01 2.35575778290E+01 2.38943079093E+01 2.42352588390E+01 2.45804364323E+01 2.49298782699E+01 2.52835894292E+01 2.56416036461E+01 2.60039300126E+01 2.63705861094E+01 2.67415858711E+01 2.71169446822E+01 2.74966636588E+01 2.78807583306E+01 2.82692299953E+01 2.86620787569E+01 2.90593084342E+01 2.94609102083E+01 2.98668813329E+01 3.02772090236E+01 3.06918810406E+01 3.11108793300E+01 3.15341838722E+01 3.19617660075E+01 3.23936004401E+01 3.28296506545E+01 3.32698772264E+01 3.37142367795E+01 3.41626805099E+01 3.46151527459E+01 3.50715930465E+01 3.55319343255E+01 3.59961038514E+01 3.64640205412E+01 3.69355982560E+01 3.74107413839E+01 3.78893489815E+01 3.83713086261E+01 3.88565032840E+01 3.93448030795E+01 3.98360722958E+01 4.03301627095E+01 4.08269178497E+01 4.13261692190E+01 4.18277380576E+01 4.23314336655E+01 4.28370533548E+01 4.33443812216E+01 4.38531894373E+01 4.43632351009E+01 4.48742619353E+01 4.53859982672E+01 4.58981572275E+01 4.64104357804E+01 4.69225140875E+01 4.74340549723E+01 4.79447031312E+01 4.84540846697E+01 4.89618061397E+01 4.94674538622E+01 4.99705934829E+01 5.04707687847E+01 5.09675013738E+01 5.14602895182E+01 5.19486077539E+01 5.24319057719E+01 5.29096077830E+01 5.33811117957E+01 5.38457886634E+01 5.43029813332E+01 5.47520041582E+01 5.51921419525E+01 5.56226493358E+01 5.60427499043E+01 5.64516354739E+01 5.68484654618E+01 5.72323659794E+01 5.76024294169E+01 5.79577136015E+01 5.82972413466E+01 5.86199998716E+01 5.89249403374E+01 5.92109774635E+01 5.94769891591E+01 5.97218163745E+01 5.99442628935E+01 6.01430953411E+01 6.03170432923E+01 6.04647995444E+01 6.05850204455E+01 6.06763265335E+01 6.07373032570E+01 6.07665019567E+01 6.07624410201E+01 6.07236073948E+01 6.06484581950E+01 6.05354227894E+01 6.03829050713E+01 6.01892861707E+01 5.99529274206E+01 5.96721739118E+01 5.93453583028E+01 5.89708051880E+01 5.85468359805E+01 5.80717743067E+01 5.75439519693E+01 5.69617155867E+01 5.63234337895E+01 5.56275052383E+01 5.48723672456E+01 5.40565053035E+01 5.31784633456E+01 5.22368548934E+01 5.12303751404E+01 5.01578139078E+01 4.90180696523E+01 4.78101644210E+01 4.65332598731E+01 4.51866743648E+01 4.37699010939E+01 4.22826273603E+01 4.07247548868E+01 3.90964212019E+01 3.73980221657E+01 3.56302353807E+01 3.37940446351E+01 3.18907652138E+01 2.99220699890E+01 2.78900160947E+01 2.57970722070E+01 2.36461459643E+01 2.14406116027E+01 1.91843372463E+01 1.68817117414E+01 1.45376705616E+01 1.21577203623E+01 9.74796166875E+00 7.31510926835E+00 4.86650945980E+00 2.41015367239E+00 -4.53124688830E-02 -2.49058546829E+00 -4.91570652156E+00 -7.31007151747E+00 -9.66244940034E+00 -1.19610102096E+01 -1.41933639434E+01 -1.63466115788E+01 -1.84074096188E+01 -2.03620493924E+01 -2.21965525489E+01 -2.38967839678E+01 -2.54485832163E+01 -2.68379156828E+01 -2.80510440571E+01 -2.90747207948E+01 -2.98964015877E+01 -3.05044796662E+01 -3.08885397893E+01 -3.10396305215E+01 -3.09505522145E+01 -3.06161573609E+01 -3.00336587576E+01 -2.92029398304E+01 -2.81268600329E+01 -2.68115468220E+01 -2.52666642324E+01 -2.35056465859E+01 -2.15458842504E+01 -1.94088471990E+01 -1.71201307623E+01 -1.47094072412E+01 -1.22102665928E+01 -9.65992954137E+00 -7.09881744067E+00 -4.56996486118E+00 -2.11826385237E+00 2.10467369600E-01 2.37059318023E+00 4.31794208793E+00 6.01124841968E+00 7.41373224805E+00 8.49478517298E+00 9.23171824568E+00 9.61151622641E+00 9.63253025276E+00 9.30602914258E+00 8.65751885890E+00 7.72773058624E+00 6.57317192928E+00 5.26613017096E+00 3.89404133555E+00 2.55796346085E+00 1.37126726247E+00 4.50467497207E-01 -5.94132017100E-02 7.35604291130E-03 -8.74804617384E-04 1.01174973888E-04 -1.14701324816E-05 1.27939697189E-06 -1.40921658907E-07 1.51914223508E-08 -1.44759989613E-09 -1.08287771535E-10 3.64902656841E-10 3 1 Beta L 649 -2.48866773601E-07 -2.56445895333E-07 -2.64255835692E-07 -2.72303624154E-07 -2.80596504271E-07 -2.89141940196E-07 -2.97947623400E-07 -3.07021479592E-07 -3.16371675857E-07 -3.26006628003E-07 -3.35935008139E-07 -3.46165752478E-07 -3.56708069382E-07 -3.67571447649E-07 -3.78765665054E-07 -3.90300797150E-07 -4.02187226336E-07 -4.14435651203E-07 -4.27057096160E-07 -4.40062921363E-07 -4.53464832934E-07 -4.67274893499E-07 -4.81505533049E-07 -4.96169560122E-07 -5.11280173333E-07 -5.26850973259E-07 -5.42895974672E-07 -5.59429619160E-07 -5.76466788122E-07 -5.94022816164E-07 -6.12113504899E-07 -6.30755137172E-07 -6.49964491715E-07 -6.69758858248E-07 -6.90156053042E-07 -7.11174434952E-07 -7.32832921947E-07 -7.55151008133E-07 -7.78148781299E-07 -8.01846941000E-07 -8.26266817186E-07 -8.51430389400E-07 -8.77360306564E-07 -9.04079907361E-07 -9.31613241243E-07 -9.59985090078E-07 -9.89220990455E-07 -1.01934725667E-06 -1.05039100440E-06 -1.08238017513E-06 -1.11534356128E-06 -1.14931083215E-06 -1.18431256057E-06 -1.22038025048E-06 -1.25754636526E-06 -1.29584435692E-06 -1.33530869627E-06 -1.37597490389E-06 -1.41787958213E-06 -1.46106044806E-06 -1.50555636738E-06 -1.55140738945E-06 -1.59865478332E-06 -1.64734107484E-06 -1.69751008501E-06 -1.74920696933E-06 -1.80247825853E-06 -1.85737190040E-06 -1.91393730295E-06 -1.97222537890E-06 -2.03228859150E-06 -2.09418100173E-06 -2.15795831699E-06 -2.22367794120E-06 -2.29139902652E-06 -2.36118252654E-06 -2.43309125119E-06 -2.50718992323E-06 -2.58354523654E-06 -2.66222591610E-06 -2.74330277992E-06 -2.82684880273E-06 -2.91293918167E-06 -3.00165140396E-06 -3.09306531670E-06 -3.18726319867E-06 -3.28432983442E-06 -3.38102560921E-06 -3.48406364239E-06 -3.59029381114E-06 -3.69974354653E-06 -3.81249767800E-06 -3.92870998754E-06 -4.04848265111E-06 -4.17186223725E-06 -4.29900670775E-06 -4.43006324331E-06 -4.56503778122E-06 -4.70418704033E-06 -4.84757037220E-06 -4.99527599720E-06 -5.14752659679E-06 -5.30437132632E-06 -5.46604221230E-06 -5.63256726411E-06 -5.80423193907E-06 -5.98110144630E-06 -6.16334379984E-06 -6.35116516482E-06 -6.54468612885E-06 -6.74408847260E-06 -6.94959345173E-06 -7.16133975819E-06 -7.37951800464E-06 -7.60437062257E-06 -7.83607407209E-06 -8.07479204726E-06 -8.32083230330E-06 -8.57434294751E-06 -8.83554115129E-06 -9.10475576659E-06 -9.38213400951E-06 -9.66795006886E-06 -9.96249687745E-06 -1.02660056344E-05 -1.05787297767E-05 -1.09010378814E-05 -1.12330898219E-05 -1.15753060325E-05 -1.19279461331E-05 -1.22912803211E-05 -1.26657391008E-05 -1.30515264180E-05 -1.34491434437E-05 -1.38588321098E-05 -1.42809860667E-05 -1.47159964129E-05 -1.51642805294E-05 -1.56261931911E-05 -1.61021922127E-05 -1.65926767137E-05 -1.70981146685E-05 -1.76189148351E-05 -1.81555980806E-05 -1.87086209966E-05 -1.92784826698E-05 -1.98657079137E-05 -2.04707992088E-05 -2.10943399292E-05 -2.17368552861E-05 -2.23989495235E-05 -2.30811863963E-05 -2.37842324546E-05 -2.45086662944E-05 -2.52551671791E-05 -2.60244061869E-05 -2.68170787117E-05 -2.76338664789E-05 -2.84755478867E-05 -2.93428720597E-05 -3.02365868588E-05 -3.11575219140E-05 -3.21065302885E-05 -3.30844182265E-05 -3.40920737053E-05 -3.51304502827E-05 -3.62004346201E-05 -3.73030000212E-05 -3.84391405012E-05 -3.96099029496E-05 -4.08163007373E-05 -4.20594421826E-05 -4.33404407345E-05 -4.46604706410E-05 -4.60206855967E-05 -4.74223210439E-05 -4.88666523743E-05 -5.03549696520E-05 -5.18886081388E-05 -5.34689601580E-05 -5.50974385096E-05 -5.67755093615E-05 -5.85046808129E-05 -6.03576627159E-05 -6.21937548143E-05 -6.40857444951E-05 -6.60353350121E-05 -6.80443488800E-05 -7.01144908982E-05 -7.22477050253E-05 -7.44458996892E-05 -7.67110010135E-05 -7.90451123485E-05 -8.14503002955E-05 -8.39287391245E-05 -8.64826344356E-05 -8.91143294007E-05 -9.18261700326E-05 -9.46205856552E-05 -9.75001201117E-05 -1.00467326111E-04 -1.03524906832E-04 -1.06675597291E-04 -1.09922256733E-04 -1.13267774016E-04 -1.16715161793E-04 -1.20267556279E-04 -1.23928137070E-04 -1.27700191737E-04 -1.31587093872E-04 -1.35592406116E-04 -1.39719681922E-04 -1.43972641151E-04 -1.48355103250E-04 -1.52871072283E-04 -1.57524544694E-04 -1.62319714461E-04 -1.67260945329E-04 -1.72352650033E-04 -1.77599397495E-04 -1.83005935291E-04 -1.88577127444E-04 -1.94317981101E-04 -2.00233651931E-04 -2.06329496730E-04 -2.12610961001E-04 -2.19083717879E-04 -2.25753583910E-04 -2.32626610670E-04 -2.39708905859E-04 -2.47006885903E-04 -2.54527105925E-04 -2.62276362883E-04 -2.70261579326E-04 -2.78489981722E-04 -2.86968972263E-04 -2.95706175123E-04 -3.04709434698E-04 -3.13986880710E-04 -3.23546846235E-04 -3.33397937096E-04 -3.43549030543E-04 -3.54009227604E-04 -3.64788008771E-04 -3.75894968819E-04 -3.87340212093E-04 -3.99133958479E-04 -4.11286892160E-04 -4.23809864367E-04 -4.36714211769E-04 -4.50011528922E-04 -4.63713750612E-04 -4.77833253061E-04 -4.92382741660E-04 -5.07375233701E-04 -5.22824314353E-04 -5.38743824545E-04 -5.55148139399E-04 -5.72051938575E-04 -5.89470510905E-04 -6.07419491017E-04 -6.25915043646E-04 -6.44973807371E-04 -6.64612925242E-04 -6.84850078516E-04 -7.05703450653E-04 -7.27191827395E-04 -7.49334557289E-04 -7.72151493635E-04 -7.95663248361E-04 -8.19890930120E-04 -8.44856332394E-04 -8.70581923935E-04 -8.97090884755E-04 -9.24406971670E-04 -9.52554877824E-04 -9.81559825196E-04 -1.01144797280E-03 -1.04224616789E-03 -1.07398210193E-03 -1.10668439002E-03 -1.14038238667E-03 -1.17510642755E-03 -1.21088773486E-03 -1.24775853446E-03 -1.28575193580E-03 -1.32490214772E-03 -1.36524435310E-03 -1.40681486292E-03 -1.44965104205E-03 -1.49379156240E-03 -1.53927471629E-03 -1.58615482527E-03 -1.63434630589E-03 -1.68451181253E-03 -1.73536779791E-03 -1.78756213115E-03 -1.84447019501E-03 -1.89771135899E-03 -1.95639537218E-03 -2.01699923009E-03 -2.07759377781E-03 -2.14037342707E-03 -2.20643425005E-03 -2.27369836320E-03 -2.34224774331E-03 -2.41371205605E-03 -2.48726510122E-03 -2.56346851839E-03 -2.64090568840E-03 -2.72140392097E-03 -2.80445056939E-03 -2.88960976979E-03 -2.97791936310E-03 -3.06833153220E-03 -3.16176363155E-03 -3.25797626716E-03 -3.35735709125E-03 -3.45976212187E-03 -3.56277605667E-03 -3.67599745556E-03 -3.78538027743E-03 -3.89797705654E-03 -4.02062794086E-03 -4.14143400663E-03 -4.26629543445E-03 -4.39929821605E-03 -4.53009866254E-03 -4.67035299061E-03 -4.80927604652E-03 -4.96047610386E-03 -5.10593809142E-03 -5.26706344412E-03 -5.42106288830E-03 -5.59448832929E-03 -5.75580910214E-03 -5.93559586993E-03 -6.11743695642E-03 -6.30070101819E-03 -6.49336833333E-03 -6.69226800672E-03 -6.89437644542E-03 -7.10500239584E-03 -7.32106574915E-03 -7.54377299662E-03 -7.77379067308E-03 -8.01009182673E-03 -8.25244987665E-03 -8.50606637910E-03 -8.76325357367E-03 -9.03089992724E-03 -9.30468229881E-03 -9.58895167997E-03 -9.87967102831E-03 -1.01805139858E-02 -1.04903824306E-02 -1.08102767859E-02 -1.11373629175E-02 -1.14783521512E-02 -1.18258339846E-02 -1.21864349213E-02 -1.25572476126E-02 -1.29386050294E-02 -1.33325927040E-02 -1.37381217405E-02 -1.41557027634E-02 -1.45865059885E-02 -1.50299270301E-02 -1.54869194588E-02 -1.59592260657E-02 -1.64436190879E-02 -1.69416396065E-02 -1.74592347159E-02 -1.79880941013E-02 -1.85381834588E-02 -1.90994776903E-02 -1.96794822485E-02 -2.02790731056E-02 -2.08957365503E-02 -2.15289819794E-02 -2.21850090336E-02 -2.28593733685E-02 -2.35533918548E-02 -2.42692393212E-02 -2.50061263602E-02 -2.57673474158E-02 -2.65477772841E-02 -2.73573401309E-02 -2.81857256986E-02 -2.90434453178E-02 -2.99244649890E-02 -3.08342062209E-02 -3.17694473624E-02 -3.27353210006E-02 -3.37282381975E-02 -3.47529669234E-02 -3.58079386066E-02 -3.68930192459E-02 -3.80143914300E-02 -3.91682947817E-02 -4.03553609376E-02 -4.15811346933E-02 -4.28412567203E-02 -4.41416157919E-02 -4.54796590293E-02 -4.68597511075E-02 -4.82794341287E-02 -4.97441360067E-02 -5.12513733177E-02 -5.28047566811E-02 -5.44052407080E-02 -5.60534490082E-02 -5.77515045737E-02 -5.95010096874E-02 -6.13025631270E-02 -6.31591213561E-02 -6.50709179598E-02 -6.70408146433E-02 -6.90693332812E-02 -7.11592037918E-02 -7.33119350395E-02 -7.55291253670E-02 -7.78130853159E-02 -8.01653376230E-02 -8.25884335637E-02 -8.50839515540E-02 -8.76545293089E-02 -9.03017316393E-02 -9.30287407640E-02 -9.58366099790E-02 -9.87292423436E-02 -1.01707785295E-01 -1.04775641542E-01 -1.07934820303E-01 -1.11188485943E-01 -1.14539117556E-01 -1.17989464155E-01 -1.21542781802E-01 -1.25201721678E-01 -1.28969383187E-01 -1.32849221502E-01 -1.36844079016E-01 -1.40957599796E-01 -1.45192836990E-01 -1.49553877674E-01 -1.54043640946E-01 -1.58666384547E-01 -1.63425525339E-01 -1.68325287914E-01 -1.73369328801E-01 -1.78562073369E-01 -1.83907546037E-01 -1.89410112932E-01 -1.95074210304E-01 -2.00904476538E-01 -2.06905375815E-01 -2.13081894635E-01 -2.19438853547E-01 -2.25981232850E-01 -2.32714298516E-01 -2.39643197843E-01 -2.46773444211E-01 -2.54110505959E-01 -2.61660090166E-01 -2.69427981747E-01 -2.77420155670E-01 -2.85642595592E-01 -2.94101642823E-01 -3.02803591655E-01 -3.11754929854E-01 -3.20962320469E-01 -3.30432571590E-01 -3.40172593555E-01 -3.50189478934E-01 -3.60490450489E-01 -3.71082904572E-01 -3.81974335342E-01 -3.93172448522E-01 -4.04685031452E-01 -4.16520101178E-01 -4.28685705435E-01 -4.41190174307E-01 -4.54041842981E-01 -4.67249311017E-01 -4.80821220499E-01 -4.94766417483E-01 -5.09093832904E-01 -5.23812556386E-01 -5.38931791385E-01 -5.54460863536E-01 -5.70409190502E-01 -5.86786346125E-01 -6.03601948982E-01 -6.20865749423E-01 -6.38587556009E-01 -6.56777267000E-01 -6.75444837437E-01 -6.94600271273E-01 -7.14253616185E-01 -7.34414937125E-01 -7.55094317732E-01 -7.76301830084E-01 -7.98047516588E-01 -8.20341387026E-01 -8.43193373527E-01 -8.66613332901E-01 -8.90610998964E-01 -9.15195978741E-01 -9.40377707319E-01 -9.66165422823E-01 -9.92568143426E-01 -1.01959461880E+00 -1.04725330027E+00 -1.07555230547E+00 -1.10449936717E+00 -1.13410179763E+00 -1.16436643521E+00 -1.19529959484E+00 -1.22690701969E+00 -1.25919381326E+00 -1.29216439171E+00 -1.32582241070E+00 -1.36017070242E+00 -1.39521120077E+00 -1.43094486954E+00 -1.46737162093E+00 -1.50449022960E+00 -1.54229824943E+00 -1.58079191585E+00 -1.61996605104E+00 -1.65981395903E+00 -1.70032732457E+00 -1.74149609222E+00 -1.78330835772E+00 -1.82575023889E+00 -1.86880575484E+00 -1.91245668691E+00 -1.95668244669E+00 -2.00145992917E+00 -2.04676336899E+00 -2.09256418371E+00 -2.13883082052E+00 -2.18552859155E+00 -2.23261950994E+00 -2.28006211918E+00 -2.32781131995E+00 -2.37581819388E+00 -2.42402982612E+00 -2.47238912332E+00 -2.52083463382E+00 -2.56930036598E+00 -2.61771560845E+00 -2.66600475187E+00 -2.71408711439E+00 -2.76187677323E+00 -2.80928240042E+00 -2.85620711017E+00 -2.90254831460E+00 -2.94819759322E+00 -2.99304057779E+00 -3.03695685591E+00 -3.07981989474E+00 -3.12149699095E+00 -3.16184924760E+00 -3.20073158432E+00 -3.23799278372E+00 -3.27347557875E+00 -3.30701678711E+00 -3.33844749627E+00 -3.36759330642E+00 -3.39427463624E+00 -3.41830709874E+00 -3.43950195277E+00 -3.45766663838E+00 -3.47260540226E+00 -3.48412002103E+00 -3.49201063016E+00 -3.49607666544E+00 -3.49611792553E+00 -3.49193576156E+00 -3.48333440229E+00 -3.47012242049E+00 -3.45211434616E+00 -3.42913243250E+00 -3.40100857722E+00 -3.36758640187E+00 -3.32872348924E+00 -3.28429377696E+00 -3.23419010203E+00 -3.17832688851E+00 -3.11664296656E+00 -3.04910450600E+00 -2.97570804361E+00 -2.89648357724E+00 -2.81149769279E+00 -2.72085668462E+00 -2.62470962097E+00 -2.52325129824E+00 -2.41672501976E+00 -2.30542512463E+00 -2.18969918346E+00 -2.06994976884E+00 -1.94663569895E+00 -1.82027264468E+00 -1.69143298410E+00 -1.56074478210E+00 -1.42888977126E+00 -1.29660020883E+00 -1.16465449015E+00 -1.03387140701E+00 -9.05102953245E-01 -7.79225602093E-01 -6.57130005937E-01 -5.39709105918E-01 -4.27844682416E-01 -3.22392429417E-01 -2.24165695901E-01 -1.33918105765E-01 -5.23253404413E-02 2.00335533258E-02 8.26948882726E-02 1.35328575043E-01 1.77755281981E-01 2.09961862681E-01 2.32114349216E-01 2.44567782057E-01 2.47872142930E-01 2.42773682458E-01 2.30210992129E-01 2.11305261323E-01 1.87344289850E-01 1.59759990392E-01 1.30099311738E-01 9.99887721316E-02 7.10928153161E-02 4.50683797483E-02 2.35035862105E-02 7.93685682890E-03 -6.54244287586E-04 5.17670849201E-05 -3.84397258638E-06 2.54459759403E-07 -1.27953018021E-08 4.62258183480E-11 1.12328425147E-10 -2.94720035560E-11 1.92141953184E-12 -5.38983350107E-12 2.89066915188E-13 4 Number of nonzero Dij 1 1 6.63252222042E-01 1 2 1.48413118913E+00 2 2 3.32468147243E+00 3 3 2.42944155561E-01 3S 0 2.00 Wavefunction 4.39214980161E-05 4.45852865073E-05 4.52591068793E-05 4.59431107447E-05 4.66374520075E-05 4.73422868974E-05 4.80577740055E-05 4.87840743196E-05 4.95213512605E-05 5.02697707189E-05 5.10295010924E-05 5.18007133238E-05 5.25835809394E-05 5.33782800879E-05 5.41849895803E-05 5.50038909297E-05 5.58351683928E-05 5.66790090108E-05 5.75356026516E-05 5.84051420527E-05 5.92878228646E-05 6.01838436944E-05 6.10934061510E-05 6.20167148901E-05 6.29539776605E-05 6.39054053507E-05 6.48712120363E-05 6.58516150283E-05 6.68468349221E-05 6.78570956467E-05 6.88826245157E-05 6.99236522778E-05 7.09804131693E-05 7.20531449664E-05 7.31420890389E-05 7.42474904044E-05 7.53695977836E-05 7.65086636560E-05 7.76649443170E-05 7.88386999355E-05 8.00301946120E-05 8.12396964389E-05 8.24674775600E-05 8.37138142322E-05 8.49789868873E-05 8.62632801956E-05 8.75669831296E-05 8.88903890290E-05 9.02337956667E-05 9.15975053163E-05 9.29818248194E-05 9.43870656549E-05 9.58135440094E-05 9.72615808479E-05 9.87315019864E-05 1.00223638165E-04 1.01738325122E-04 1.03275903670E-04 1.04836719773E-04 1.06421124622E-04 1.08029474718E-04 1.09662131948E-04 1.11319463669E-04 1.13001842790E-04 1.14709647855E-04 1.16443263131E-04 1.18203078690E-04 1.19989490502E-04 1.21802900519E-04 1.23643716769E-04 1.25512353447E-04 1.27409231006E-04 1.29334776256E-04 1.31289422457E-04 1.33273609414E-04 1.35287783584E-04 1.37332398166E-04 1.39407913213E-04 1.41514795729E-04 1.43653519775E-04 1.45824566579E-04 1.48028424639E-04 1.50265589839E-04 1.52536565556E-04 1.54841862775E-04 1.57182000202E-04 1.59557504387E-04 1.61968909832E-04 1.64416759122E-04 1.66901603041E-04 1.69424000695E-04 1.71984519644E-04 1.74583736023E-04 1.77222234676E-04 1.79900609283E-04 1.82619462502E-04 1.85379406095E-04 1.88181061071E-04 1.91025057825E-04 1.93912036281E-04 1.96842646031E-04 1.99817546488E-04 2.02837407031E-04 2.05902907153E-04 2.09014736620E-04 2.12173595622E-04 2.15380194929E-04 2.18635256057E-04 2.21939511426E-04 2.25293704524E-04 2.28698590078E-04 2.32154934220E-04 2.35663514664E-04 2.39225120875E-04 2.42840554252E-04 2.46510628306E-04 2.50236168844E-04 2.54018014153E-04 2.57857015192E-04 2.61754035778E-04 2.65709952789E-04 2.69725656351E-04 2.73802050047E-04 2.77940051117E-04 2.82140590662E-04 2.86404613859E-04 2.90733080168E-04 2.95126963553E-04 2.99587252697E-04 3.04114951228E-04 3.08711077944E-04 3.13376667039E-04 3.18112768341E-04 3.22920447544E-04 3.27800786453E-04 3.32754883219E-04 3.37783852597E-04 3.42888826188E-04 3.48070952697E-04 3.53331398194E-04 3.58671346373E-04 3.64091998818E-04 3.69594575279E-04 3.75180313940E-04 3.80850471702E-04 3.86606324463E-04 3.92449167409E-04 3.98380315301E-04 4.04401102776E-04 4.10512884644E-04 4.16717036193E-04 4.23014953501E-04 4.29408053749E-04 4.35897775540E-04 4.42485579223E-04 4.49172947223E-04 4.55961384371E-04 4.62852418250E-04 4.69847599531E-04 4.76948502329E-04 4.84156724552E-04 4.91473888264E-04 4.98901640052E-04 5.06441651391E-04 5.14095619028E-04 5.21865265357E-04 5.29752338813E-04 5.37758614261E-04 5.45885893399E-04 5.54136005164E-04 5.62510806141E-04 5.71012180985E-04 5.79642042842E-04 5.88402333785E-04 5.97295025246E-04 6.06322118463E-04 6.15485644933E-04 6.24787666866E-04 6.34230277652E-04 6.43815602332E-04 6.53545798076E-04 6.63423054674E-04 6.73449595023E-04 6.83627675633E-04 6.93959587133E-04 7.04447654789E-04 7.15094239027E-04 7.25901735966E-04 7.36872577961E-04 7.48009234145E-04 7.59314210993E-04 7.70790052881E-04 7.82439342666E-04 7.94264702264E-04 8.06268793244E-04 8.18454317427E-04 8.30824017496E-04 8.43380677617E-04 8.56127124065E-04 8.69066225862E-04 8.82200895424E-04 8.95534089222E-04 9.09068808445E-04 9.22808099682E-04 9.36755055605E-04 9.50912815673E-04 9.65284566834E-04 9.79873544254E-04 9.94683032039E-04 1.00971636398E-03 1.02497692432E-03 1.04046814849E-03 1.05619352390E-03 1.07215659075E-03 1.08836094279E-03 1.10481022816E-03 1.12150815021E-03 1.13845846832E-03 1.15566499879E-03 1.17313161566E-03 1.19086225160E-03 1.20886089884E-03 1.22713161000E-03 1.24567849907E-03 1.26450574231E-03 1.28361757921E-03 1.30301831345E-03 1.32271231386E-03 1.34270401543E-03 1.36299792031E-03 1.38359859880E-03 1.40451069046E-03 1.42573890507E-03 1.44728802379E-03 1.46916290016E-03 1.49136846128E-03 1.51390970887E-03 1.53679172043E-03 1.56001965039E-03 1.58359873130E-03 1.60753427499E-03 1.63183167380E-03 1.65649640178E-03 1.68153401599E-03 1.70695015770E-03 1.73275055371E-03 1.75894101766E-03 1.78552745134E-03 1.81251584604E-03 1.83991228393E-03 1.86772293941E-03 1.89595408057E-03 1.92461207058E-03 1.95370336917E-03 1.98323453411E-03 2.01321222267E-03 2.04364319320E-03 2.07453430663E-03 2.10589252806E-03 2.13772492839E-03 2.17003868586E-03 2.20284108778E-03 2.23613953217E-03 2.26994152943E-03 2.30425470413E-03 2.33908679672E-03 2.37444566530E-03 2.41033928748E-03 2.44677576217E-03 2.48376331149E-03 2.52131028263E-03 2.55942514979E-03 2.59811651617E-03 2.63739311592E-03 2.67726381616E-03 2.71773761909E-03 2.75882366402E-03 2.80053122951E-03 2.84286973554E-03 2.88584874570E-03 2.92947796940E-03 2.97376726414E-03 3.01872663782E-03 3.06436625106E-03 3.11069641961E-03 3.15772761672E-03 3.20547047563E-03 3.25393579206E-03 3.30313452673E-03 3.35307780795E-03 3.40377693426E-03 3.45524337706E-03 3.50748878334E-03 3.56052497845E-03 3.61436396886E-03 3.66901794507E-03 3.72449928445E-03 3.78082055422E-03 3.83799451442E-03 3.89603412100E-03 3.95495252890E-03 4.01476309515E-03 4.07547938219E-03 4.13711516103E-03 4.19968441463E-03 4.26320134125E-03 4.32768035790E-03 4.39313610383E-03 4.45958344409E-03 4.52703747317E-03 4.59551351866E-03 4.66502714500E-03 4.73559415734E-03 4.80723060539E-03 4.87995278738E-03 4.95377725411E-03 5.02872081304E-03 5.10480053248E-03 5.18203374582E-03 5.26043805591E-03 5.34003133945E-03 5.42083175142E-03 5.50285772982E-03 5.58612800021E-03 5.67066158049E-03 5.75647778576E-03 5.84359623331E-03 5.93203684755E-03 6.02181986524E-03 6.11296584068E-03 6.20549565106E-03 6.29943050186E-03 6.39479193250E-03 6.49160182186E-03 6.58988239422E-03 6.68965622495E-03 6.79094624675E-03 6.89377575561E-03 6.99816841709E-03 7.10414827283E-03 7.21173974694E-03 7.32096765271E-03 7.43185719944E-03 7.54443399935E-03 7.65872407468E-03 7.77475386496E-03 7.89255023436E-03 8.01214047937E-03 8.13355233641E-03 8.25681398981E-03 8.38195407988E-03 8.50900171116E-03 8.63798646094E-03 8.76893838779E-03 8.90188804052E-03 9.03686646717E-03 9.17390522431E-03 9.31303638649E-03 9.45429255598E-03 9.59770687267E-03 9.74331302432E-03 9.89114525692E-03 1.00412383854E-02 1.01936278046E-02 1.03483495004E-02 1.05054400614E-02 1.06649366906E-02 1.08268772174E-02 1.09913001102E-02 1.11582444889E-02 1.13277501383E-02 1.14998575210E-02 1.16746077918E-02 1.18520428112E-02 1.20322051602E-02 1.22151381552E-02 1.24008858634E-02 1.25894931181E-02 1.27810055354E-02 1.29754695305E-02 1.31729323349E-02 1.33734420137E-02 1.35770474841E-02 1.37837985339E-02 1.39937458400E-02 1.42069409892E-02 1.44234364975E-02 1.46432858314E-02 1.48665434294E-02 1.50932647239E-02 1.53235061645E-02 1.55573252410E-02 1.57947805077E-02 1.60359316089E-02 1.62808393040E-02 1.65295654944E-02 1.67821732510E-02 1.70387268422E-02 1.72992917634E-02 1.75639347668E-02 1.78327238930E-02 1.81057285024E-02 1.83830193092E-02 1.86646684151E-02 1.89507493448E-02 1.92413370827E-02 1.95365081110E-02 1.98363404480E-02 2.01409136896E-02 2.04503090501E-02 2.07646094062E-02 2.10838993413E-02 2.14082651921E-02 2.17377950963E-02 2.20725790422E-02 2.24127089200E-02 2.27582785754E-02 2.31093838638E-02 2.34661227081E-02 2.38285951573E-02 2.41969034475E-02 2.45711520660E-02 2.49514478159E-02 2.53378998851E-02 2.57306199161E-02 2.61297220796E-02 2.65353231499E-02 2.69475425835E-02 2.73665026008E-02 2.77923282702E-02 2.82251475959E-02 2.86650916083E-02 2.91122944589E-02 2.95668935173E-02 3.00290294728E-02 3.04988464395E-02 3.09764920650E-02 3.14621176442E-02 3.19558782356E-02 3.24579327839E-02 3.29684442457E-02 3.34875797208E-02 3.40155105877E-02 3.45524126449E-02 3.50984662570E-02 3.56538565065E-02 3.62187733508E-02 3.67934117861E-02 3.73779720160E-02 3.79726596278E-02 3.85776857743E-02 3.91932673628E-02 3.98196272513E-02 4.04569944515E-02 4.11056043396E-02 4.17656988750E-02 4.24375268265E-02 4.31213440076E-02 4.38174135198E-02 4.45260060047E-02 4.52473999061E-02 4.59818817406E-02 4.67297463783E-02 4.74912973343E-02 4.82668470691E-02 4.90567173017E-02 4.98612393316E-02 5.06807543741E-02 5.15156139060E-02 5.23661800240E-02 5.32328258154E-02 5.41159357411E-02 5.50159060323E-02 5.59331451001E-02 5.68680739588E-02 5.78211266637E-02 5.87927507624E-02 5.97834077620E-02 6.07935736096E-02 6.18237391898E-02 6.28744108361E-02 6.39461108593E-02 6.50393780909E-02 6.61547684435E-02 6.72928554869E-02 6.84542310412E-02 6.96395057860E-02 7.08493098868E-02 7.20842936378E-02 7.33451281214E-02 7.46325058847E-02 7.59471416314E-02 7.72897729317E-02 7.86611609464E-02 8.00620911676E-02 8.14933741747E-02 8.29558464042E-02 8.44503709342E-02 8.59778382816E-02 8.75391672118E-02 8.91353055595E-02 9.07672310597E-02 9.24359521867E-02 9.41425090009E-02 9.58879740005E-02 9.76734529767E-02 9.95000858700E-02 1.01369047625E-01 1.03281549043E-01 1.05238837622E-01 1.07242198397E-01 1.09292954753E-01 1.11392469233E-01 1.13542144315E-01 1.15743423163E-01 1.17997790353E-01 1.20306772551E-01 1.22671939156E-01 1.25094902882E-01 1.27577320297E-01 1.30120892280E-01 1.32727364416E-01 1.35398527301E-01 1.38136216756E-01 1.40942313939E-01 1.43818745338E-01 1.46767482643E-01 1.49790542468E-01 1.52889985932E-01 1.56067918059E-01 1.59326486998E-01 1.62667883044E-01 1.66094337436E-01 1.69608120916E-01 1.73211542031E-01 1.76906945154E-01 1.80696708200E-01 1.84583240020E-01 1.88568977439E-01 1.92656381921E-01 1.96847935819E-01 2.01146138204E-01 2.05553500214E-01 2.10072539925E-01 2.14705776675E-01 2.19455724840E-01 2.24324887005E-01 2.29315746506E-01 2.34430759300E-01 2.39672345133E-01 2.45042877953E-01 2.50544675552E-01 2.56179988376E-01 2.61950987480E-01 2.67859751581E-01 2.73908253174E-01 2.80098343679E-01 2.86431737578E-01 2.92909995506E-01 2.99534506283E-01 3.06306467834E-01 3.13226866993E-01 3.20296458173E-01 3.27515740869E-01 3.34884936010E-01 3.42403961146E-01 3.50072404480E-01 3.57889497774E-01 3.65854088138E-01 3.73964608760E-01 3.82219048626E-01 3.90614921291E-01 3.99149232803E-01 4.07818448862E-01 4.16618461362E-01 4.25544554439E-01 4.34591370211E-01 4.43752874394E-01 4.53022322016E-01 4.62392223492E-01 4.71854311322E-01 4.81399507741E-01 4.91017893668E-01 5.00698679327E-01 5.10430176974E-01 5.20199776180E-01 5.29993922165E-01 5.39798097721E-01 5.49596809284E-01 5.59373577780E-01 5.69110934856E-01 5.78790425198E-01 5.88392615606E-01 5.97897111571E-01 6.07282582069E-01 6.16526793331E-01 6.25606652339E-01 6.34498260771E-01 6.43176980121E-01 6.51617508671E-01 6.59793970940E-01 6.67680020170E-01 6.75248954305E-01 6.82473845834E-01 6.89327685683E-01 6.95783541225E-01 7.01814728236E-01 7.07394996411E-01 7.12498727797E-01 7.17101147172E-01 7.21178543074E-01 7.24708497805E-01 7.27670124304E-01 7.30044307340E-01 7.31813945983E-01 7.32964193780E-01 7.33482692545E-01 7.33359795083E-01 7.32588771609E-01 7.31165994073E-01 7.29091092039E-01 7.26367073264E-01 7.23000401688E-01 7.19001025159E-01 7.14382344987E-01 7.09161119269E-01 7.03357292038E-01 6.96993740494E-01 6.90095933168E-01 6.82691492614E-01 6.74809657432E-01 6.66480639903E-01 6.57734877473E-01 6.48602178719E-01 6.39110767279E-01 6.29286230605E-01 6.19150384277E-01 6.08720066973E-01 5.98005886202E-01 5.87010938492E-01 5.75756116506E-01 5.64262535081E-01 5.52551474952E-01 5.40644327408E-01 5.28562539044E-01 5.16327556885E-01 5.03960773899E-01 4.91483471783E-01 4.78916740164E-01 4.66274499266E-01 4.53584281566E-01 4.40866455899E-01 4.28140989930E-01 4.15427433437E-01 4.02744875515E-01 3.90111897869E-01 3.77546518063E-01 3.65066165623E-01 3.52687673802E-01 3.40427210517E-01 3.28300225581E-01 3.16321434454E-01 3.04504791804E-01 2.92863466597E-01 2.81409820704E-01 2.70155391194E-01 2.59110876464E-01 2.48286126287E-01 2.37690135838E-01 2.27331043687E-01 2.17216133731E-01 2.07351840952E-01 1.97743760887E-01 1.88396662615E-01 1.79314505062E-01 1.70500456378E-01 1.61956916113E-01 1.53685539925E-01 1.45687266505E-01 1.37962346434E-01 1.30510372655E-01 1.23330312284E-01 1.16420539446E-01 1.09778868875E-01 1.03402590023E-01 9.72885014078E-02 9.14329450061E-02 8.58318404616E-02 8.04807189418E-02 7.53747564726E-02 7.05088066161E-02 6.58774323710E-02 6.14749372023E-02 5.72953951223E-02 5.33326797678E-02 4.95804924367E-02 4.60323890606E-02 4.26818061070E-02 3.95220854165E-02 3.65464979870E-02 3.37482667273E-02 3.11205882025E-02 2.86566533972E-02 2.63496675209E-02 2.41928688735E-02 2.21795467882E-02 2.03030586585E-02 1.85568460517E-02 1.69344499014E-02 1.54295247691E-02 1.40358521542E-02 1.27473528319E-02 1.15580981933E-02 1.04623205622E-02 9.45442246376E-03 8.52898482406E-03 7.68077408219E-03 6.90474820490E-03 6.19606159909E-03 5.55006892653E-03 4.96232783338E-03 4.42860061583E-03 3.94485485223E-03 3.50726304018E-03 3.11220128510E-03 2.75624709380E-03 2.43617633291E-03 2.14895941714E-03 1.89175679659E-03 1.66191381532E-03 1.45695501540E-03 1.27457796165E-03 1.11264666210E-03 9.69184658106E-04 8.42367856474E-04 7.30517172921E-04 6.32091053206E-04 5.45677934275E-04 4.69988703498E-04 4.03849209446E-04 3.46192872736E-04 2.96053440431E-04 2.52557922371E-04 2.14919742672E-04 1.82432134614E-04 1.54461802231E-04 1.30442867224E-04 1.09871115357E-04 9.22985523106E-05 7.73282750751E-05 6.46096614548E-05 5.38338769920E-05 4.47296957952E-05 3.70596292218E-05 3.06163542002E-05 2.52194311432E-05 2.07122998884E-05 1.69595408984E-05 1.38443880344E-05 1.12664785617E-05 9.13982563796E-06 7.39099834367E-06 5.95749431741E-06 4.78629023575E-06 3.83255569766E-06 3.05851651999E-06 2.43245399721E-06 1.92782730694E-06 1.52250693123E-06 1.19810769692E-06 9.39410797897E-07 7.33864935687E-07 5.71157488671E-07 4.42847384070E-07 3.42052091866E-07 2.63181878429E-07 2.01715144286E-07 1.54009321049E-07 1.17138318891E-07 8.87278839623E-08 6.69249715910E-08 5.02638358821E-08 3.75867204131E-08 2.79831238793E-08 2.07401583684E-08 1.53021611903E-08 1.12379886025E-08 8.21465542860E-09 5.97619093658E-09 4.32676095813E-09 3.11726158854E-09 2.23472336852E-09 1.59397896897E-09 1.13114431424E-09 7.98544881403E-10 5.60787538599E-10 3.91735507763E-10 2.72191460715E-10 1.88132825403E-10 1.29375373635E-10 8.85672172686E-11 6.04364535818E-11 4.12327473589E-11 2.79653424935E-11 1.88535834314E-11 1.26335181200E-11 8.41339908275E-12 5.56794576067E-12 3.66145546022E-12 2.39224731405E-12 1.55277893984E-12 1.00120142672E-12 6.41206539277E-13 4.07844682952E-13 2.57612598932E-13 1.61573152303E-13 1.00613158802E-13 6.21980597877E-14 3.81669650400E-14 2.32454896782E-14 1.40501469569E-14 8.42682932439E-15 5.01461973138E-15 2.96040298910E-15 1.73360619828E-15 1.00689418432E-15 5.79958812366E-16 3.31234655373E-16 1.87561723459E-16 1.05284922936E-16 5.85793456517E-17 3.23013883150E-17 1.76496988496E-17 9.55505202279E-18 5.12445590401E-18 2.72219854338E-18 1.43214377235E-18 7.46078854048E-19 3.84812950642E-19 1.96478952823E-19 9.92927131243E-20 4.96576638826E-20 2.45727810866E-20 1.20296219778E-20 5.82517209579E-21 2.78967143908E-21 1.32102850202E-21 6.18461084119E-22 2.86205997614E-22 1.30898665842E-22 5.91567995207E-23 2.64124529328E-23 1.16484433086E-23 5.07342683315E-24 2.18186219731E-24 9.26323001486E-25 3.88170335944E-25 1.60517089978E-25 6.54895835772E-26 2.63564466567E-26 1.04610551998E-26 4.09399307822E-27 1.57946237113E-27 6.00576355055E-28 2.25023938043E-28 8.30604148032E-29 3.01971691613E-29 1.08104935863E-29 3.81005160968E-30 1.32165954410E-30 4.51136062771E-31 1.51491733944E-31 5.00329838981E-32 1.62480392306E-32 5.18694882123E-33 1.62733552818E-33 5.01628705401E-34 1.51884010282E-34 4.51594505788E-35 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 3P 1 2.00 Wavefunction 1.05883958815E-08 1.09108605427E-08 1.12431457147E-08 1.15855504768E-08 1.19383830162E-08 1.23019609062E-08 1.26766113913E-08 1.30626716823E-08 1.34604892594E-08 1.38704221854E-08 1.42928394276E-08 1.47281211899E-08 1.51766592553E-08 1.56388573384E-08 1.61151314486E-08 1.66059102648E-08 1.71116355210E-08 1.76327624041E-08 1.81697599634E-08 1.87231115330E-08 1.92933151666E-08 1.98808840860E-08 2.04863471429E-08 2.11102492949E-08 2.17531520959E-08 2.24156342019E-08 2.30982918916E-08 2.38017396028E-08 2.45266104860E-08 2.52735569739E-08 2.60432513688E-08 2.68363864475E-08 2.76536760850E-08 2.84958558973E-08 2.93636839030E-08 3.02579412058E-08 3.11794326977E-08 3.21289877831E-08 3.31074611257E-08 3.41157334175E-08 3.51547121716E-08 3.62253325390E-08 3.73285581501E-08 3.84653819826E-08 3.96368272545E-08 4.08439483457E-08 4.20878317464E-08 4.33695970357E-08 4.46903978887E-08 4.60514231155E-08 4.74538977304E-08 4.88990840551E-08 5.03882828550E-08 5.19228345092E-08 5.35041202179E-08 5.51335632448E-08 5.68126301984E-08 5.85428323524E-08 6.03257270052E-08 6.21629188824E-08 6.40560615804E-08 6.60068590554E-08 6.80170671566E-08 7.00884952069E-08 7.22230076312E-08 7.44225256345E-08 7.66890289313E-08 7.90245575274E-08 8.14312135560E-08 8.39111631698E-08 8.64666384904E-08 8.90999396181E-08 9.18134367012E-08 9.46095720701E-08 9.74908624349E-08 1.00459901151E-07 1.03519360554E-07 1.06671994363E-07 1.09920640160E-07 1.13268221947E-07 1.16717752772E-07 1.20272337445E-07 1.23935175332E-07 1.27709563233E-07 1.31598898353E-07 1.35606681354E-07 1.39736519512E-07 1.43992129958E-07 1.48377343029E-07 1.52896105711E-07 1.57552485196E-07 1.62350672537E-07 1.67294986428E-07 1.72389877082E-07 1.77639930245E-07 1.83049871318E-07 1.88624569612E-07 1.94369042730E-07 2.00288461084E-07 2.06388152550E-07 2.12673607259E-07 2.19150482544E-07 2.25824608029E-07 2.32701990874E-07 2.39788821187E-07 2.47091477592E-07 2.54616532970E-07 2.62370760376E-07 2.70361139137E-07 2.78594861130E-07 2.87079337257E-07 2.95822204119E-07 3.04831330881E-07 3.14114826363E-07 3.23681046334E-07 3.33538601034E-07 3.43696362925E-07 3.54163474672E-07 3.64949357380E-07 3.76063719066E-07 3.87516563401E-07 3.99318198712E-07 4.11479247264E-07 4.24010654814E-07 4.36923700469E-07 4.50230006835E-07 4.63941550480E-07 4.78070672710E-07 4.92630090682E-07 5.07632908847E-07 5.23092630744E-07 5.39023171157E-07 5.55438868638E-07 5.72354498413E-07 5.89785285679E-07 6.07746919309E-07 6.26255565973E-07 6.45327884689E-07 6.64981041817E-07 6.85232726510E-07 7.06101166635E-07 7.27605145180E-07 7.49764017158E-07 7.72597727032E-07 7.96126826661E-07 8.20372493801E-07 8.45356551165E-07 8.71101486069E-07 8.97630470664E-07 9.24967382801E-07 9.53136827516E-07 9.82164159179E-07 1.01207550432E-06 1.04289778512E-06 1.07465874369E-06 1.10738696699E-06 1.14111191259E-06 1.17586393517E-06 1.21167431385E-06 1.24857528035E-06 1.28660004795E-06 1.32578284148E-06 1.36615892802E-06 1.40776464871E-06 1.45063745145E-06 1.49481592458E-06 1.54033983163E-06 1.58725014710E-06 1.63558909337E-06 1.68540017865E-06 1.73672823619E-06 1.78961946460E-06 1.84412146944E-06 1.90028330609E-06 1.95815552386E-06 2.01779021152E-06 2.07924104418E-06 2.14256333159E-06 2.20781406793E-06 2.27505198308E-06 2.34433759555E-06 2.41573326686E-06 2.48930325775E-06 2.56511378595E-06 2.64323308584E-06 2.72373146981E-06 2.80668139160E-06 2.89215751146E-06 2.98023676338E-06 3.07099842434E-06 3.16452418562E-06 3.26089822638E-06 3.36020728941E-06 3.46254075917E-06 3.56799074228E-06 3.67665215042E-06 3.78862278571E-06 3.90400342880E-06 4.02289792954E-06 4.14541330043E-06 4.27165981300E-06 4.40175109701E-06 4.53580424273E-06 4.67393990633E-06 4.81628241848E-06 4.96295989626E-06 5.11410435846E-06 5.26985184440E-06 5.43034253637E-06 5.59572088582E-06 5.76613574336E-06 5.94174049272E-06 6.12269318882E-06 6.30915670001E-06 6.50129885468E-06 6.69929259228E-06 6.90331611901E-06 7.11355306818E-06 7.33019266549E-06 7.55342989937E-06 7.78346569644E-06 8.02050710237E-06 8.26476746822E-06 8.51646664246E-06 8.77583116885E-06 9.04309449033E-06 9.31849715914E-06 9.60228705327E-06 9.89471959964E-06 1.01960580039E-05 1.05065734874E-05 1.08265455313E-05 1.11562621280E-05 1.14960200403E-05 1.18461250689E-05 1.22068923270E-05 1.25786465245E-05 1.29617222598E-05 1.33564643211E-05 1.37632279968E-05 1.41823793953E-05 1.46142957741E-05 1.50593658798E-05 1.55179902977E-05 1.59905818127E-05 1.64775657801E-05 1.69793805090E-05 1.74964776568E-05 1.80293226352E-05 1.85783950296E-05 1.91441890303E-05 1.97272138775E-05 2.03279943196E-05 2.09470710855E-05 2.15850013708E-05 2.22423593400E-05 2.29197366426E-05 2.36177429459E-05 2.43370064835E-05 2.50781746208E-05 2.58419144377E-05 2.66289133285E-05 2.74398796212E-05 2.82755432141E-05 2.91366562336E-05 3.00239937104E-05 3.09383542771E-05 3.18805608871E-05 3.28514615551E-05 3.38519301202E-05 3.48828670322E-05 3.59452001622E-05 3.70398856374E-05 3.81679087015E-05 3.93302846014E-05 4.05280595007E-05 4.17623114213E-05 4.30341512133E-05 4.43447235549E-05 4.56952079819E-05 4.70868199500E-05 4.85208119275E-05 4.99984745233E-05 5.15211376475E-05 5.30901717086E-05 5.47069888462E-05 5.63730442021E-05 5.80898372294E-05 5.98589130417E-05 6.16818638035E-05 6.35603301628E-05 6.54960027273E-05 6.74906235855E-05 6.95459878742E-05 7.16639453936E-05 7.38464022721E-05 7.60953226804E-05 7.84127305998E-05 8.08007116422E-05 8.32614149272E-05 8.57970550154E-05 8.84099139008E-05 9.11023430638E-05 9.38767655867E-05 9.67356783339E-05 9.96816541977E-05 1.02717344413E-04 1.05845480943E-04 1.09068878936E-04 1.12390439257E-04 1.15813151101E-04 1.19340094677E-04 1.22974443982E-04 1.26719469653E-04 1.30578541915E-04 1.34555133603E-04 1.38652823297E-04 1.42875298529E-04 1.47226359108E-04 1.51709920535E-04 1.56330017525E-04 1.61090807632E-04 1.65996574995E-04 1.71051734182E-04 1.76260834169E-04 1.81628562425E-04 1.87159749128E-04 1.92859371508E-04 1.98732558326E-04 2.04784594481E-04 2.11020925765E-04 2.17447163756E-04 2.24069090867E-04 2.30892665542E-04 2.37924027614E-04 2.45169503824E-04 2.52635613508E-04 2.60329074458E-04 2.68256808961E-04 2.76425950017E-04 2.84843847757E-04 2.93518076043E-04 3.02456439276E-04 3.11666979413E-04 3.21157983189E-04 3.30937989565E-04 3.41015797404E-04 3.51400473369E-04 3.62101360079E-04 3.73128084491E-04 3.84490566559E-04 3.96199028136E-04 4.08264002162E-04 4.20696342119E-04 4.33507231785E-04 4.46708195271E-04 4.60311107372E-04 4.74328204233E-04 4.88772094328E-04 5.03655769786E-04 5.18992618051E-04 5.34796433901E-04 5.51081431828E-04 5.67862258794E-04 5.85154007379E-04 6.02972229320E-04 6.21332949465E-04 6.40252680154E-04 6.59748436023E-04 6.79837749274E-04 7.00538685392E-04 7.21869859348E-04 7.43850452291E-04 7.66500228743E-04 7.89839554316E-04 8.13889413968E-04 8.38671430806E-04 8.64207885467E-04 8.90521736074E-04 9.17636638808E-04 9.45576969091E-04 9.74367843420E-04 1.00403514185E-03 1.03460553118E-03 1.06610648878E-03 1.09856632725E-03 1.13201421968E-03 1.16648022581E-03 1.20199531887E-03 1.23859141330E-03 1.27630139330E-03 1.31515914219E-03 1.35519957271E-03 1.39645865822E-03 1.43897346482E-03 1.48278218447E-03 1.52792416907E-03 1.57443996561E-03 1.62237135234E-03 1.67176137604E-03 1.72265439042E-03 1.77509609569E-03 1.82913357924E-03 1.88481535768E-03 1.94219141999E-03 2.00131327208E-03 2.06223398264E-03 2.12500823037E-03 2.18969235259E-03 2.25634439542E-03 2.32502416531E-03 2.39579328223E-03 2.46871523439E-03 2.54385543465E-03 2.62128127852E-03 2.70106220402E-03 2.78326975322E-03 2.86797763567E-03 2.95526179368E-03 3.04520046964E-03 3.13787427519E-03 3.23336626261E-03 3.33176199818E-03 3.43314963786E-03 3.53762000512E-03 3.64526667110E-03 3.75618603715E-03 3.87047741985E-03 3.98824313845E-03 4.10958860499E-03 4.23462241702E-03 4.36345645307E-03 4.49620597093E-03 4.63298970882E-03 4.77392998953E-03 4.91915282756E-03 5.06878803952E-03 5.22296935763E-03 5.38183454658E-03 5.54552552381E-03 5.71418848326E-03 5.88797402273E-03 6.06703727490E-03 6.25153804218E-03 6.44164093543E-03 6.63751551662E-03 6.83933644569E-03 7.04728363152E-03 7.26154238728E-03 7.48230359015E-03 7.70976384562E-03 7.94412565642E-03 8.18559759625E-03 8.43439448835E-03 8.69073758912E-03 8.95485477688E-03 9.22698074583E-03 9.50735720548E-03 9.79623308552E-03 1.00938647463E-02 1.04005161953E-02 1.07164593091E-02 1.10419740618E-02 1.13773487591E-02 1.17228802795E-02 1.20788743210E-02 1.24456456549E-02 1.28235183860E-02 1.32128262202E-02 1.36139127381E-02 1.40271316766E-02 1.44528472170E-02 1.48914342813E-02 1.53432788345E-02 1.58087781962E-02 1.62883413585E-02 1.67823893125E-02 1.72913553820E-02 1.78156855660E-02 1.83558388886E-02 1.89122877570E-02 1.94855183283E-02 2.00760308839E-02 2.06843402127E-02 2.13109760022E-02 2.19564832379E-02 2.26214226115E-02 2.33063709370E-02 2.40119215751E-02 2.47386848655E-02 2.54872885678E-02 2.62583783101E-02 2.70526180447E-02 2.78706905127E-02 2.87132977144E-02 2.95811613881E-02 3.04750234946E-02 3.13956467084E-02 3.23438149150E-02 3.33203337133E-02 3.43260309231E-02 3.53617570962E-02 3.64283860323E-02 3.75268152960E-02 3.86579667369E-02 3.98227870102E-02 4.10222480968E-02 4.22573478223E-02 4.35291103732E-02 4.48385868092E-02 4.61868555689E-02 4.75750229691E-02 4.90042236938E-02 5.04756212722E-02 5.19904085424E-02 5.35498080990E-02 5.51550727222E-02 5.68074857837E-02 5.85083616285E-02 6.02590459273E-02 6.20609159968E-02 6.39153810833E-02 6.58238826048E-02 6.77878943482E-02 6.98089226143E-02 7.18885063073E-02 7.40282169610E-02 7.62296586959E-02 7.84944681003E-02 8.08243140277E-02 8.32208973029E-02 8.56859503271E-02 8.82212365736E-02 9.08285499647E-02 9.35097141175E-02 9.62665814488E-02 9.91010321264E-02 1.02014972854E-01 1.05010335476E-01 1.08089075389E-01 1.11253169739E-01 1.14504615399E-01 1.17845426694E-01 1.21277632876E-01 1.24803275303E-01 1.28424404330E-01 1.32143075866E-01 1.35961347596E-01 1.39881274826E-01 1.43904905936E-01 1.48034277423E-01 1.52271408489E-01 1.56618295161E-01 1.61076903916E-01 1.65649164773E-01 1.70336963828E-01 1.75142135203E-01 1.80066452383E-01 1.85111618898E-01 1.90279258336E-01 1.95570903650E-01 2.00987985726E-01 2.06531821200E-01 2.12203599478E-01 2.18004368953E-01 2.23935022391E-01 2.29996281466E-01 2.36188680433E-01 2.42512548927E-01 2.48967993893E-01 2.55554880636E-01 2.62272813009E-01 2.69121112758E-01 2.76098798044E-01 2.83204561189E-01 2.90436745695E-01 2.97793322590E-01 3.05271866197E-01 3.12869529407E-01 3.20583018579E-01 3.28408568195E-01 3.36341915432E-01 3.44378274827E-01 3.52512313233E-01 3.60738125306E-01 3.69049209785E-01 3.77438446832E-01 3.85898076777E-01 3.94419680603E-01 4.02994162556E-01 4.11611735293E-01 4.20261908026E-01 4.28933478116E-01 4.37614526652E-01 4.46292418522E-01 4.54953807551E-01 4.63584647276E-01 4.72170207949E-01 4.80695100362E-01 4.89143307095E-01 4.97498221763E-01 5.05742696834E-01 5.13859100528E-01 5.21829383265E-01 5.29635154067E-01 5.37257767201E-01 5.44678419257E-01 5.51878256679E-01 5.58838493638E-01 5.65540539876E-01 5.71966137963E-01 5.78097509099E-01 5.83917506300E-01 5.89409773463E-01 5.94558908407E-01 5.99350627589E-01 6.03771929736E-01 6.07811255165E-01 6.11458637062E-01 6.14705840494E-01 6.17546484413E-01 6.19976141428E-01 6.21992409648E-01 6.23594950488E-01 6.24785485987E-01 6.25567748944E-01 6.25947379061E-01 6.25931758310E-01 6.25529779007E-01 6.24751538510E-01 6.23607955225E-01 6.22110301622E-01 6.20269651380E-01 6.18096239529E-01 6.15598736644E-01 6.12783440735E-01 6.09653393536E-01 6.06207431354E-01 6.02439184522E-01 5.98336043956E-01 5.93905190322E-01 5.89154273479E-01 5.84091397068E-01 5.78725102059E-01 5.73064349449E-01 5.67118502112E-01 5.60897305679E-01 5.54410864736E-01 5.47669590567E-01 5.40684215358E-01 5.33465846966E-01 5.26025874537E-01 5.18375893201E-01 5.10527713721E-01 5.02493339215E-01 4.94284934150E-01 4.85914777211E-01 4.77390377423E-01 4.68729032611E-01 4.59943278200E-01 4.51045630960E-01 4.42048575079E-01 4.32964530934E-01 4.23805821828E-01 4.14584641319E-01 4.05313021499E-01 3.96002802523E-01 3.86665603688E-01 3.77312796349E-01 3.67955478911E-01 3.58604454101E-01 3.49270208703E-01 3.39962895865E-01 3.30692320061E-01 3.21467924742E-01 3.12298782650E-01 3.03193588745E-01 2.94160655647E-01 2.85207911460E-01 2.76342899807E-01 2.67572781910E-01 2.58904340473E-01 2.50343985172E-01 2.41897759499E-01 2.33571348718E-01 2.25370088682E-01 2.17298975273E-01 2.09362674200E-01 2.01565530943E-01 1.93911580597E-01 1.86404557413E-01 1.79047903852E-01 1.71844778964E-01 1.64798065974E-01 1.57910378940E-01 1.51184068422E-01 1.44621226114E-01 1.38223688429E-01 1.31993039077E-01 1.25930610707E-01 1.20037485722E-01 1.14314496398E-01 1.08762224482E-01 1.03381000456E-01 9.81709026748E-02 9.31317565713E-02 8.82631341674E-02 8.35643540720E-02 7.90344821666E-02 7.46723331453E-02 7.04764730545E-02 6.64452229467E-02 6.25766637353E-02 5.88686423001E-02 5.53187788667E-02 5.19244756470E-02 4.86829267033E-02 4.55911289700E-02 4.26458943470E-02 3.98438627558E-02 3.71815160409E-02 3.46551925809E-02 3.22611024722E-02 2.99953431400E-02 2.78539152331E-02 2.58327386598E-02 2.39276686269E-02 2.21345115498E-02 2.04490407107E-02 1.88670115497E-02 1.73841764860E-02 1.59962991749E-02 1.46991681191E-02 1.34886095651E-02 1.23604996245E-02 1.13107755727E-02 1.03354462888E-02 9.43060180959E-03 8.59242198116E-03 7.81718420015E-03 7.10127024589E-03 6.44117221187E-03 5.83349755211E-03 5.27497326438E-03 4.76244923778E-03 4.29290079687E-03 3.86343047884E-03 3.47126908353E-03 3.11377603909E-03 2.78843912795E-03 2.49287361988E-03 2.22482085937E-03 1.98214635577E-03 1.76283742424E-03 1.56500042548E-03 1.38685765160E-03 1.22674390414E-03 1.08310280926E-03 9.54482913330E-04 8.39533600242E-04 7.37000870007E-04 6.45723015716E-04 5.64626233856E-04 4.92720200451E-04 4.29093643077E-04 3.72909936296E-04 3.23402745528E-04 2.79871741888E-04 2.41678408056E-04 2.08241952846E-04 1.79035349799E-04 1.53581512903E-04 1.31449620426E-04 1.12251595842E-04 9.56387529860E-05 8.12986108899E-05 6.89518822134E-05 5.83496378796E-05 4.92689336061E-05 4.14966567820E-05 3.48599068276E-05 2.92075731109E-05 2.44063915009E-05 2.03391583501E-05 1.69030809996E-05 1.40082595086E-05 1.15762938920E-05 9.53901082927E-06 7.83730356154E-06 6.42007853642E-06 5.24330227241E-06 4.26914189693E-06 3.46519285621E-06 2.80378739469E-06 2.26137755032E-06 1.81798660264E-06 1.45672313650E-06 1.16335214006E-06 9.25917833675E-07 7.34413222091E-07 5.80491670124E-07 4.57216116360E-07 3.58841856935E-07 2.80629147510E-07 2.18682183376E-07 1.69811322391E-07 1.31415711357E-07 1.01383762212E-07 7.80091997797E-08 5.99206683498E-08 4.60231420042E-08 3.52043266062E-08 2.68169301211E-08 2.03417351627E-08 1.53640286967E-08 1.15539968554E-08 8.65049221238E-09 6.44765541401E-09 4.78394074560E-09 3.53315622018E-09 2.59718338780E-09 1.90009061419E-09 1.38339645065E-09 1.00227732415E-09 7.22546550141E-10 5.18260043311E-10 3.69828507955E-10 2.62536747332E-10 1.85388442544E-10 1.30209694393E-10 9.09571478965E-11 6.31869523521E-11 4.36494437715E-11 2.99815353507E-11 2.04746005903E-11 1.39003398769E-11 9.38091574557E-12 6.29268116349E-12 4.19524322836E-12 2.77951573293E-12 1.82991425918E-12 1.19701716812E-12 7.77921621852E-13 5.02220325934E-13 3.22056608467E-13 2.05118806622E-13 1.29738617676E-13 8.14850762767E-14 5.08142745301E-14 3.14590313585E-14 1.93334490739E-14 1.17931385300E-14 7.13931416459E-15 4.28884984077E-15 2.55641827461E-15 1.51174456843E-15 8.86805306396E-16 5.15974996841E-16 2.97732253695E-16 1.70359164697E-16 9.66478552730E-17 5.43563040078E-17 3.03027208339E-17 1.67428546497E-17 9.16716101689E-18 4.97322479094E-18 2.67287534241E-18 1.42296853292E-18 7.50283731706E-19 3.91747404492E-19 2.02522302701E-19 1.03647901270E-19 5.25052712113E-20 2.63228462800E-20 1.30581644033E-20 6.40887091234E-21 3.11143506478E-21 1.49399258216E-21 7.09368991545E-22 3.33010941400E-22 1.54537086957E-22 7.08792479615E-23 3.21248228546E-23 3.85819620019E-09 3.97569578397E-09 4.09677376384E-09 4.22153911826E-09 4.35010414455E-09 4.48258456002E-09 4.61909960612E-09 4.75977215571E-09 4.90472882370E-09 5.05410008103E-09 5.20802037204E-09 5.36662823555E-09 5.53006642949E-09 5.69848205944E-09 5.87202671102E-09 6.05085658633E-09 6.23513264453E-09 6.42502074672E-09 6.62069180524E-09 6.82232193751E-09 7.03009262452E-09 7.24419087417E-09 7.46480938965E-09 7.69214674282E-09 7.92640755297E-09 8.16780267100E-09 8.41654936918E-09 8.67287153673E-09 8.93699988131E-09 9.20917213673E-09 9.48963327685E-09 9.77863573613E-09 1.00764396368E-08 1.03833130231E-08 1.06995321024E-08 1.10253814938E-08 1.13611544844E-08 1.17071532934E-08 1.20636893437E-08 1.24310835428E-08 1.28096665710E-08 1.31997791795E-08 1.36017724971E-08 1.40160083458E-08 1.44428595669E-08 1.48827103567E-08 1.53359566116E-08 1.58030062853E-08 1.62842797553E-08 1.67802102018E-08 1.72912439972E-08 1.78178411081E-08 1.83604755092E-08 1.89196356100E-08 1.94958246944E-08 2.00895613734E-08 2.07013800525E-08 2.13318314122E-08 2.19814829038E-08 2.26509192602E-08 2.33407430222E-08 2.40515750807E-08 2.47840552359E-08 2.55388427727E-08 2.63166170545E-08 2.71180781346E-08 2.79439473862E-08 2.87949681516E-08 2.96719064117E-08 3.05755514750E-08 3.15067166883E-08 3.24662401687E-08 3.34549855579E-08 3.44738427999E-08 3.55237289416E-08 3.66055889583E-08 3.77203966047E-08 3.88691552909E-08 4.00528989856E-08 4.12726931470E-08 4.25296356818E-08 4.38248579332E-08 4.51595256994E-08 4.65348402829E-08 4.79520395717E-08 4.94123991537E-08 5.09172334647E-08 5.24678969718E-08 5.40657853922E-08 5.57123369495E-08 5.74090336688E-08 5.91574027100E-08 6.09590177429E-08 6.28155003633E-08 6.47285215530E-08 6.66998031837E-08 6.87311195667E-08 7.08242990502E-08 7.29812256653E-08 7.52038408211E-08 7.74941450531E-08 7.98541998231E-08 8.22861293754E-08 8.47921226487E-08 8.73744352462E-08 9.00353914663E-08 9.27773863945E-08 9.56028880595E-08 9.85144396545E-08 1.01514661827E-07 1.04606255037E-07 1.07792001987E-07 1.11074770132E-07 1.14457514251E-07 1.17943279117E-07 1.21535202232E-07 1.25236516650E-07 1.29050553892E-07 1.32980746943E-07 1.37030633340E-07 1.41203858360E-07 1.45504178298E-07 1.49935463851E-07 1.54501703600E-07 1.59207007603E-07 1.64055611093E-07 1.69051878291E-07 1.74200306335E-07 1.79505529326E-07 1.84972322504E-07 1.90605606542E-07 1.96410451981E-07 2.02392083788E-07 2.08555886064E-07 2.14907406891E-07 2.21452363325E-07 2.28196646543E-07 2.35146327145E-07 2.42307660623E-07 2.49687092987E-07 2.57291266575E-07 2.65127026025E-07 2.73201424444E-07 2.81521729751E-07 2.90095431227E-07 2.98930246252E-07 3.08034127255E-07 3.17415268874E-07 3.27082115334E-07 3.37043368046E-07 3.47307993446E-07 3.57885231064E-07 3.68784601843E-07 3.80015916713E-07 3.91589285424E-07 4.03515125645E-07 4.15804172348E-07 4.28467487472E-07 4.41516469880E-07 4.54962865628E-07 4.68818778536E-07 4.83096681091E-07 4.97809425673E-07 5.12970256131E-07 5.28592819706E-07 5.44691179323E-07 5.61279826250E-07 5.78373693150E-07 5.95988167528E-07 6.14139105586E-07 6.32842846501E-07 6.52116227142E-07 6.71976597229E-07 6.92441834961E-07 7.13530363113E-07 7.35261165630E-07 7.57653804725E-07 7.80728438492E-07 8.04505839067E-07 8.29007411334E-07 8.54255212204E-07 8.80271970481E-07 9.07081107336E-07 9.34706757401E-07 9.63173790510E-07 9.92507834101E-07 1.02273529630E-06 1.05388338971E-06 1.08598015592E-06 1.11905449080E-06 1.15313617046E-06 1.18825587816E-06 1.22444523189E-06 1.26173681290E-06 1.30016419503E-06 1.33976197497E-06 1.38056580342E-06 1.42261241724E-06 1.46593967254E-06 1.51058657877E-06 1.55659333393E-06 1.60400136074E-06 1.65285334402E-06 1.70319326911E-06 1.75506646156E-06 1.80851962796E-06 1.86360089806E-06 1.92035986813E-06 1.97884764569E-06 2.03911689558E-06 2.10122188743E-06 2.16521854460E-06 2.23116449461E-06 2.29911912110E-06 2.36914361736E-06 2.44130104155E-06 2.51565637352E-06 2.59227657346E-06 2.67123064230E-06 2.75258968391E-06 2.83642696926E-06 2.92281800254E-06 3.01184058927E-06 3.10357490648E-06 3.19810357508E-06 3.29551173444E-06 3.39588711916E-06 3.49932013832E-06 3.60590395707E-06 3.71573458071E-06 3.82891094138E-06 3.94553498738E-06 4.06571177524E-06 4.18954956455E-06 4.31715991579E-06 4.44865779106E-06 4.58416165791E-06 4.72379359643E-06 4.86767940948E-06 5.01594873644E-06 5.16873517031E-06 5.32617637849E-06 5.48841422724E-06 5.65559490991E-06 5.82786907913E-06 6.00539198310E-06 6.18832360593E-06 6.37682881244E-06 6.57107749727E-06 6.77124473863E-06 6.97751095674E-06 7.19006207717E-06 7.40908969913E-06 7.63479126900E-06 7.86737025912E-06 8.10703635211E-06 8.35400563086E-06 8.60850077430E-06 8.87075125928E-06 9.14099356858E-06 9.41947140534E-06 9.70643591410E-06 1.00021459086E-05 1.03068681068E-05 1.06208773725E-05 1.09444569655E-05 1.12778987984E-05 1.16215037018E-05 1.19755816978E-05 1.23404522814E-05 1.27164447114E-05 1.31038983096E-05 1.35031627695E-05 1.39145984743E-05 1.43385768252E-05 1.47754805796E-05 1.52257041996E-05 1.56896542112E-05 1.61677495755E-05 1.66604220702E-05 1.71681166837E-05 1.76912920209E-05 1.82304207226E-05 1.87859898965E-05 1.93585015626E-05 1.99484731120E-05 2.05564377805E-05 2.11829451360E-05 2.18285615822E-05 2.24938708770E-05 2.31794746675E-05 2.38859930421E-05 2.46140650990E-05 2.53643495331E-05 2.61375252410E-05 2.69342919448E-05 2.77553708360E-05 2.86015052391E-05 2.94734612954E-05 3.03720286705E-05 3.12980212809E-05 3.22522780461E-05 3.32356636631E-05 3.42490694055E-05 3.52934139480E-05 3.63696442165E-05 3.74787362660E-05 3.86216961852E-05 3.97995610304E-05 4.10133997887E-05 4.22643143722E-05 4.35534406436E-05 4.48819494739E-05 4.62510478348E-05 4.76619799253E-05 4.91160283346E-05 5.06145152418E-05 5.21588036546E-05 5.37502986873E-05 5.53904488802E-05 5.70807475613E-05 5.88227342511E-05 6.06179961151E-05 6.24681694610E-05 6.43749412841E-05 6.63400508654E-05 6.83652914194E-05 7.04525117957E-05 7.26036182384E-05 7.48205761989E-05 7.71054122129E-05 7.94602158335E-05 8.18871416349E-05 8.43884112732E-05 8.69663156251E-05 8.96232169871E-05 9.23615513590E-05 9.51838307912E-05 9.80926458190E-05 1.01090667976E-04 1.04180652390E-04 1.07365440466E-04 1.10647962661E-04 1.14031241353E-04 1.17518393805E-04 1.21112635227E-04 1.24817281952E-04 1.28635754708E-04 1.32571582008E-04 1.36628403659E-04 1.40809974386E-04 1.45120167581E-04 1.49562979190E-04 1.54142531722E-04 1.58863078412E-04 1.63729007514E-04 1.68744846761E-04 1.73915267963E-04 1.79245091789E-04 1.84739292696E-04 1.90403004055E-04 1.96241523438E-04 2.02260318114E-04 2.08465030726E-04 2.14861485190E-04 2.21455692788E-04 2.28253858498E-04 2.35262387551E-04 2.42487892222E-04 2.49937198880E-04 2.57617355290E-04 2.65535638196E-04 2.73699561177E-04 2.82116882799E-04 2.90795615079E-04 2.99744032260E-04 3.08970679931E-04 3.18484384480E-04 3.28294262917E-04 3.38409733076E-04 3.48840524207E-04 3.59596687976E-04 3.70688609906E-04 3.82127021254E-04 3.93923011363E-04 4.06088040494E-04 4.18633953183E-04 4.31572992116E-04 4.44917812568E-04 4.58681497432E-04 4.72877572841E-04 4.87520024445E-04 5.02623314339E-04 5.18202398701E-04 5.34272746151E-04 5.50850356882E-04 5.67951782586E-04 5.85594147216E-04 6.03795168638E-04 6.22573181183E-04 6.41947159183E-04 6.61936741506E-04 6.82562257149E-04 7.03844751956E-04 7.25806016480E-04 7.48468615089E-04 7.71855916338E-04 7.95992124699E-04 8.20902313700E-04 8.46612460550E-04 8.73149482321E-04 9.00541273772E-04 9.28816746890E-04 9.58005872242E-04 9.88139722226E-04 1.01925051633E-03 1.05137166847E-03 1.08453783657E-03 1.11878497444E-03 1.15415038614E-03 1.19067278283E-03 1.22839234247E-03 1.26735077225E-03 1.30759137405E-03 1.34915911314E-03 1.39210069012E-03 1.43646461643E-03 1.48230129350E-03 1.52966309587E-03 1.57860445837E-03 1.62918196764E-03 1.68145445826E-03 1.73548311359E-03 1.79133157181E-03 1.84906603725E-03 1.90875539736E-03 1.97047134569E-03 2.03428851113E-03 2.10028459379E-03 2.16854050788E-03 2.23914053201E-03 2.31217246730E-03 2.38772780367E-03 2.46590189495E-03 2.54679414307E-03 2.63050819204E-03 2.71715213211E-03 2.80683871488E-03 2.89968557974E-03 2.99581549245E-03 3.09535659651E-03 3.19844267803E-03 3.30521344488E-03 3.41581482086E-03 3.53039925593E-03 3.64912605318E-03 3.77216171367E-03 3.89968030011E-03 4.03186382046E-03 4.16890263250E-03 4.31099587079E-03 4.45835189706E-03 4.61118877553E-03 4.76973477455E-03 4.93422889609E-03 5.10492143456E-03 5.28207456690E-03 5.46596297544E-03 5.65687450567E-03 5.85511086069E-03 6.06098833472E-03 6.27483858762E-03 6.49700946302E-03 6.72786585236E-03 6.96779060769E-03 7.21718550574E-03 7.47647226650E-03 7.74609362917E-03 8.02651448884E-03 8.31822309742E-03 8.62173233238E-03 8.93758103709E-03 9.26633543700E-03 9.60859063569E-03 9.96497219549E-03 1.03361378072E-02 1.07227790542E-02 1.11256232754E-02 1.15454355340E-02 1.19830206960E-02 1.24392256263E-02 1.29149415069E-02 1.34111062858E-02 1.39287072622E-02 1.44687838155E-02 1.50324302869E-02 1.56207990193E-02 1.62351035663E-02 1.68766220777E-02 1.75467008698E-02 1.82467581923E-02 1.89782881984E-02 1.97428651312E-02 2.05421477345E-02 2.13778839003E-02 2.22519155633E-02 2.31661838541E-02 2.41227345229E-02 2.51237236451E-02 2.61714236222E-02 2.72682294886E-02 2.84166655384E-02 2.96193922835E-02 3.08792137568E-02 3.21990851718E-02 3.35821209512E-02 3.50316031374E-02 3.65509901945E-02 3.81439262151E-02 3.98142505405E-02 4.15660078044E-02 4.34034584079E-02 4.53310894329E-02 4.73536259996E-02 4.94760430699E-02 5.17035776994E-02 5.40417417354E-02 5.64963349557E-02 5.90734586415E-02 6.17795295705E-02 6.46212944138E-02 6.76058445148E-02 7.07406310217E-02 7.40334803389E-02 7.74926098545E-02 8.11266438951E-02 8.49446298454E-02 8.89560543651E-02 9.31708596188E-02 9.75994594268E-02 1.02252755227E-01 1.07142151724E-01 1.12279572086E-01 1.17677472533E-01 1.23348856128E-01 1.29307285585E-01 1.35566894858E-01 1.42142399271E-01 1.49049103906E-01 1.56302909948E-01 1.63920318655E-01 1.71918432581E-01 1.80314953647E-01 1.89128177634E-01 1.98376984614E-01 2.08080824805E-01 2.18259699311E-01 2.28934135131E-01 2.40125153837E-01 2.51854233215E-01 2.64143261182E-01 2.77014481225E-01 2.90490428573E-01 3.04593856296E-01 3.19347650498E-01 3.34774733723E-01 3.50897955734E-01 3.67739970763E-01 3.85323100388E-01 4.03669181176E-01 4.22799396298E-01 4.42734090358E-01 4.63492566759E-01 4.85092867027E-01 5.07551531652E-01 5.30883342126E-01 5.55101044083E-01 5.80215051648E-01 6.06233133353E-01 6.33160080294E-01 6.60997357554E-01 6.89742740261E-01 7.19389936151E-01 7.49928196921E-01 7.81341921230E-01 8.13610252761E-01 8.46706677358E-01 8.80598623926E-01 9.15247074445E-01 9.50606189145E-01 9.86622953608E-01 1.02323685528E+00 1.06037959750E+00 1.09797485993E+00 1.13593811463E+00 1.17417650780E+00 1.21258881728E+00 1.25106549639E+00 1.28948881454E+00 1.32773310496E+00 1.36566512949E+00 1.40314456947E+00 1.44002465097E+00 1.47615291097E+00 1.51137210935E+00 1.54552128932E+00 1.57843698635E+00 1.60995458228E+00 1.63990979817E+00 1.66814031504E+00 1.69448750793E+00 1.71879827363E+00 1.74092692794E+00 1.76073714347E+00 1.77810389420E+00 1.79291536831E+00 1.80507480680E+00 1.81450222190E+00 1.82113594625E+00 1.82493396245E+00 1.82587496180E+00 1.82395908213E+00 1.81920827700E+00 1.81166627291E+00 1.80139807666E+00 1.78848900321E+00 1.77304320323E+00 1.75518168070E+00 1.73503980280E+00 1.71276431792E+00 1.68850991117E+00 1.66243534150E+00 1.63469921893E+00 1.60545549512E+00 1.57484875482E+00 1.54300941054E+00 1.51004891720E+00 1.47605513953E+00 1.44108802196E+00 1.40517572681E+00 1.36843696157E+00 1.33098993291E+00 1.29295178520E+00 1.25443806502E+00 1.21556221258E+00 1.17643508287E+00 1.13716449829E+00 1.09785481995E+00 1.05860644888E+00 1.01950265881E+00 9.80649020726E-01 9.42132905240E-01 9.04036547820E-01 8.66436997859E-01 8.29405981418E-01 7.93009777974E-01 7.57309088027E-01 7.22349755478E-01 6.88191002528E-01 6.54877009644E-01 6.22446398649E-01 5.90932385249E-01 5.60362906557E-01 5.30760769365E-01 5.02143824012E-01 4.74525161577E-01 4.47913331816E-01 4.22312579164E-01 3.97723093927E-01 3.74141275769E-01 3.51560006508E-01 3.29968929267E-01 3.09354731069E-01 2.89701426064E-01 2.70990636728E-01 2.53201870539E-01 2.36312789865E-01 2.20299473025E-01 2.05136664762E-01 1.90798014615E-01 1.77256301980E-01 1.64483646888E-01 1.52451705833E-01 1.41131852205E-01 1.30495341131E-01 1.20513458758E-01 1.11157656174E-01 1.02399668370E-01 9.42116187714E-02 8.65661100055E-02 7.94363016696E-02 7.27959759391E-02 6.66195919227E-02 6.08823297020E-02 5.55601250161E-02 5.06296955498E-02 4.60685597709E-02 4.18550492310E-02 3.79683152007E-02 3.43883304563E-02 3.10958869713E-02 2.80725901936E-02 2.53008505162E-02 2.27638724677E-02 2.04456420726E-02 1.83309127556E-02 1.64051900879E-02 1.46547156137E-02 1.30664499296E-02 1.16280551439E-02 1.03278767998E-02 9.15492531332E-03 8.09885695617E-03 7.14995439561E-03 6.29910679886E-03 5.53778950670E-03 4.85804328579E-03 4.25245317707E-03 3.71412696799E-03 3.23667332878E-03 2.81417966524E-03 2.44118975246E-03 2.11268122505E-03 1.82404300824E-03 1.57105278130E-03 1.34985456942E-03 1.15693656209E-03 9.89109256250E-04 8.43484019527E-04 7.17452164692E-04 6.08664620030E-04 5.15012272545E-04 4.34607051974E-04 3.65763813803E-04 3.06983069147E-04 2.56934598792E-04 2.14441978176E-04 1.78468029798E-04 1.48101209768E-04 1.22542926006E-04 1.01095777221E-04 8.31526942051E-05 6.81869583892E-05 5.57430668713E-05 4.54284084523E-05 3.69057114002E-05 2.98862208128E-05 2.41235614246E-05 1.94082404887E-05 1.55627448648E-05 1.24371865861E-05 9.90545188517E-06 7.86180984276E-06 6.21793840081E-06 4.90032738580E-06 3.84802033102E-06 3.01065921141E-06 2.34679864291E-06 1.82245859784E-06 1.40988719895E-06 1.08650763761E-06 8.34025679763E-07 6.37676551394E-07 4.85592209013E-07 3.68272086024E-07 2.78142350223E-07 2.09190505295E-07 1.56663816851E-07 1.16821541896E-07 8.67322927743E-08 6.41090779404E-08 4.71756393264E-08 3.45586578620E-08 2.52012337656E-08 1.82937761447E-08 1.32190667947E-08 9.50880549955E-09 6.80940791911E-09 4.85488308013E-09 3.44396079343E-09 2.43043516596E-09 1.70616970696E-09 1.19134671771E-09 8.27364290890E-10 5.71429154870E-10 3.92463137233E-10 2.68021413132E-10 1.81985590163E-10 1.22846725661E-10 8.24348542694E-11 5.49844568743E-11 3.64511550603E-11 2.40151281430E-11 1.57224500682E-11 1.02276581256E-11 6.61015120371E-12 4.24408489972E-12 2.70677655175E-12 1.71464774022E-12 1.07872559504E-12 6.73941173855E-13 4.18093161425E-13 2.57534959977E-13 1.57505438428E-13 9.56437953630E-14 5.76717707437E-14 3.45401785244E-14 2.05573345424E-14 1.21708705274E-14 7.18097300242E-15 4.23625920470E-15 2.47868922560E-15 1.43829548306E-15 8.27572379193E-16 4.72106755719E-16 2.66989686720E-16 1.49662031053E-16 8.31445206835E-17 4.57721781177E-17 2.49663857535E-17 1.34907231001E-17 7.22068868444E-18 3.82757147936E-18 2.00911966902E-18 1.04414703425E-18 5.37186944987E-19 2.73546250594E-19 1.37851087400E-19 6.87377492580E-20 3.39091290281E-20 1.65464055070E-20 7.98518189510E-21 3.81054788313E-21 1.79778492398E-21 8.38418538664E-22 3.86438897387E-22 1.76003160451E-22 7.91956724506E-23 3.52001314902E-23 1.54514154193E-23 6.69717239189E-24 2.86570020155E-24 1.21032409949E-24 5.04450511563E-25 2.07440918114E-25 8.41474496601E-26 3.36642178331E-26 1.32796353116E-26 5.16418099205E-27 1.97934130803E-27 7.47564506190E-28 2.78156232773E-28 1.01939613481E-28 3.67884659134E-29 1.30705487895E-29 4.57074328035E-30 1.57284730291E-30 5.32460394731E-31 1.77288989780E-31 5.80444899922E-32 1.86816158577E-32 5.90921557078E-33 1.83650977988E-33 5.60646363642E-34 1.68073682219E-34 4.94659296424E-35 1.42885251921E-35 4.04967889139E-36 1.12585135613E-36 3.06932057852E-37 8.20305661827E-38 2.14857748755E-38 5.51360700993E-39 1.38578447256E-39 3.41031315170E-40 8.21472527422E-41 1.93620563246E-41 4.46402767112E-42 1.00640873233E-42 2.21792574184E-43 4.77634224905E-44 1.00477355832E-44 2.06400848688E-45 TDDFPT/Examples/pseudo/O.pz-rrkjus.UPF0000644000175000017500000160306712341371476015745 0ustar mbamba Generated using Andrea Dal Corso code (rrkj3) Author: Andrea Dal Corso Generation date: unknown Info: O LDA 2s2 2p4 RRKJ3 US 1 The Pseudo was generated with a Scalar-Relativistic Calculation 1.40000000000E+00 Local Potential cutoff radius nl pn l occ Rcut Rcut US E pseu 2S 1 0 2.00 1.40000000000 1.60000000000 0.00000000000 2S 1 0 0.00 1.40000000000 1.60000000000 0.00000000000 2P 2 1 4.00 1.40000000000 1.60000000000 0.00000000000 2P 2 1 0.00 1.40000000000 1.60000000000 0.00000000000 3D 3 2 -2.00 1.40000000000 1.40000000000 0.00000000000 0 Version Number O Element US Ultrasoft pseudopotential F Nonlinear Core Correction SLA PZ NOGX NOGC PZ Exchange-Correlation functional 6.00000000000 Z valence -31.31422127500 Total energy 0.0000000 0.0000000 Suggested cutoff for wfc and rho 2 Max angular momentum component 1269 Number of points in mesh 2 4 Number of Wavefunctions, Number of Projectors Wavefunctions nl l occ 2S 0 2.00 2P 1 4.00 3.09844022083E-04 3.12958006275E-04 3.16103286529E-04 3.19280177374E-04 3.22488996503E-04 3.25730064801E-04 3.29003706377E-04 3.32310248597E-04 3.35650022119E-04 3.39023360923E-04 3.42430602346E-04 3.45872087114E-04 3.49348159380E-04 3.52859166752E-04 3.56405460335E-04 3.59987394761E-04 3.63605328227E-04 3.67259622528E-04 3.70950643098E-04 3.74678759041E-04 3.78444343172E-04 3.82247772053E-04 3.86089426030E-04 3.89969689271E-04 3.93888949806E-04 3.97847599564E-04 4.01846034413E-04 4.05884654201E-04 4.09963862793E-04 4.14084068112E-04 4.18245682184E-04 4.22449121172E-04 4.26694805424E-04 4.30983159513E-04 4.35314612276E-04 4.39689596864E-04 4.44108550778E-04 4.48571915916E-04 4.53080138621E-04 4.57633669716E-04 4.62232964560E-04 4.66878483086E-04 4.71570689849E-04 4.76310054074E-04 4.81097049701E-04 4.85932155435E-04 4.90815854788E-04 4.95748636136E-04 5.00730992761E-04 5.05763422903E-04 5.10846429808E-04 5.15980521782E-04 5.21166212238E-04 5.26404019750E-04 5.31694468102E-04 5.37038086344E-04 5.42435408842E-04 5.47886975334E-04 5.53393330979E-04 5.58955026419E-04 5.64572617827E-04 5.70246666967E-04 5.75977741249E-04 5.81766413785E-04 5.87613263448E-04 5.93518874926E-04 5.99483838787E-04 6.05508751531E-04 6.11594215655E-04 6.17740839710E-04 6.23949238364E-04 6.30220032461E-04 6.36553849087E-04 6.42951321629E-04 6.49413089838E-04 6.55939799898E-04 6.62532104484E-04 6.69190662832E-04 6.75916140805E-04 6.82709210955E-04 6.89570552595E-04 6.96500851865E-04 7.03500801801E-04 7.10571102402E-04 7.17712460707E-04 7.24925590855E-04 7.32211214167E-04 7.39570059210E-04 7.47002861876E-04 7.54510365450E-04 7.62093320689E-04 7.69752485896E-04 7.77488626993E-04 7.85302517600E-04 7.93194939114E-04 8.01166680782E-04 8.09218539786E-04 8.17351321319E-04 8.25565838664E-04 8.33862913282E-04 8.42243374886E-04 8.50708061529E-04 8.59257819687E-04 8.67893504343E-04 8.76615979073E-04 8.85426116132E-04 8.94324796539E-04 9.03312910172E-04 9.12391355849E-04 9.21561041421E-04 9.30822883866E-04 9.40177809374E-04 9.49626753447E-04 9.59170660987E-04 9.68810486392E-04 9.78547193653E-04 9.88381756449E-04 9.98315158244E-04 1.00834839239E-03 1.01848246221E-03 1.02871838113E-03 1.03905717274E-03 1.04949987094E-03 1.06004751999E-03 1.07070117469E-03 1.08146190039E-03 1.09233077318E-03 1.10330887997E-03 1.11439731855E-03 1.12559719780E-03 1.13690963771E-03 1.14833576953E-03 1.15987673588E-03 1.17153369088E-03 1.18330780021E-03 1.19520024132E-03 1.20721220344E-03 1.21934488779E-03 1.23159950765E-03 1.24397728848E-03 1.25647946808E-03 1.26910729667E-03 1.28186203705E-03 1.29474496470E-03 1.30775736793E-03 1.32090054798E-03 1.33417581919E-03 1.34758450909E-03 1.36112795857E-03 1.37480752198E-03 1.38862456728E-03 1.40258047620E-03 1.41667664433E-03 1.43091448131E-03 1.44529541093E-03 1.45982087130E-03 1.47449231497E-03 1.48931120910E-03 1.50427903559E-03 1.51939729124E-03 1.53466748788E-03 1.55009115256E-03 1.56566982763E-03 1.58140507100E-03 1.59729845619E-03 1.61335157256E-03 1.62956602543E-03 1.64594343626E-03 1.66248544281E-03 1.67919369928E-03 1.69606987653E-03 1.71311566217E-03 1.73033276081E-03 1.74772289417E-03 1.76528780127E-03 1.78302923862E-03 1.80094898039E-03 1.81904881855E-03 1.83733056311E-03 1.85579604226E-03 1.87444710256E-03 1.89328560913E-03 1.91231344584E-03 1.93153251549E-03 1.95094474000E-03 1.97055206061E-03 1.99035643806E-03 2.01035985282E-03 2.03056430524E-03 2.05097181579E-03 2.07158442522E-03 2.09240419482E-03 2.11343320659E-03 2.13467356344E-03 2.15612738942E-03 2.17779682994E-03 2.19968405195E-03 2.22179124421E-03 2.24412061744E-03 2.26667440460E-03 2.28945486109E-03 2.31246426498E-03 2.33570491722E-03 2.35917914189E-03 2.38288928645E-03 2.40683772192E-03 2.43102684317E-03 2.45545906913E-03 2.48013684305E-03 2.50506263271E-03 2.53023893073E-03 2.55566825474E-03 2.58135314771E-03 2.60729617815E-03 2.63349994038E-03 2.65996705480E-03 2.68670016814E-03 2.71370195373E-03 2.74097511178E-03 2.76852236963E-03 2.79634648202E-03 2.82445023139E-03 2.85283642814E-03 2.88150791090E-03 2.91046754686E-03 2.93971823200E-03 2.96926289141E-03 2.99910447959E-03 3.02924598071E-03 3.05969040896E-03 3.09044080879E-03 3.12150025528E-03 3.15287185440E-03 3.18455874334E-03 3.21656409079E-03 3.24889109734E-03 3.28154299571E-03 3.31452305111E-03 3.34783456158E-03 3.38148085829E-03 3.41546530591E-03 3.44979130291E-03 3.48446228191E-03 3.51948171004E-03 3.55485308927E-03 3.59057995678E-03 3.62666588527E-03 3.66311448338E-03 3.69992939599E-03 3.73711430462E-03 3.77467292779E-03 3.81260902140E-03 3.85092637909E-03 3.88962883263E-03 3.92872025230E-03 3.96820454726E-03 4.00808566598E-03 4.04836759661E-03 4.08905436738E-03 4.13015004699E-03 4.17165874504E-03 4.21358461245E-03 4.25593184182E-03 4.29870466793E-03 4.34190736809E-03 4.38554426261E-03 4.42961971520E-03 4.47413813346E-03 4.51910396926E-03 4.56452171922E-03 4.61039592516E-03 4.65673117453E-03 4.70353210090E-03 4.75080338440E-03 4.79854975219E-03 4.84677597897E-03 4.89548688737E-03 4.94468734855E-03 4.99438228258E-03 5.04457665900E-03 5.09527549730E-03 5.14648386738E-03 5.19820689015E-03 5.25044973793E-03 5.30321763506E-03 5.35651585838E-03 5.41034973775E-03 5.46472465659E-03 5.51964605246E-03 5.57511941753E-03 5.63115029919E-03 5.68774430058E-03 5.74490708113E-03 5.80264435718E-03 5.86096190250E-03 5.91986554889E-03 5.97936118677E-03 6.03945476576E-03 6.10015229525E-03 6.16145984506E-03 6.22338354598E-03 6.28592959045E-03 6.34910423311E-03 6.41291379149E-03 6.47736464659E-03 6.54246324355E-03 6.60821609229E-03 6.67462976815E-03 6.74171091254E-03 6.80946623365E-03 6.87790250705E-03 6.94702657644E-03 7.01684535427E-03 7.08736582248E-03 7.15859503318E-03 7.23054010935E-03 7.30320824556E-03 7.37660670868E-03 7.45074283862E-03 7.52562404905E-03 7.60125782815E-03 7.67765173938E-03 7.75481342217E-03 7.83275059277E-03 7.91147104496E-03 7.99098265084E-03 8.07129336165E-03 8.15241120852E-03 8.23434430330E-03 8.31710083938E-03 8.40068909247E-03 8.48511742147E-03 8.57039426928E-03 8.65652816367E-03 8.74352771808E-03 8.83140163255E-03 8.92015869455E-03 9.00980777985E-03 9.10035785343E-03 9.19181797038E-03 9.28419727679E-03 9.37750501067E-03 9.47175050286E-03 9.56694317799E-03 9.66309255541E-03 9.76020825014E-03 9.85829997383E-03 9.95737753574E-03 1.00574508437E-02 1.01585299051E-02 1.02606248280E-02 1.03637458219E-02 1.04679031990E-02 1.05731073752E-02 1.06793688709E-02 1.07866983124E-02 1.08951064327E-02 1.10046040728E-02 1.11152021824E-02 1.12269118215E-02 1.13397441612E-02 1.14537104847E-02 1.15688221888E-02 1.16850907848E-02 1.18025278995E-02 1.19211452769E-02 1.20409547788E-02 1.21619683862E-02 1.22841982005E-02 1.24076564450E-02 1.25323554654E-02 1.26583077317E-02 1.27855258394E-02 1.29140225104E-02 1.30438105943E-02 1.31749030702E-02 1.33073130474E-02 1.34410537670E-02 1.35761386031E-02 1.37125810644E-02 1.38503947953E-02 1.39895935772E-02 1.41301913301E-02 1.42722021139E-02 1.44156401298E-02 1.45605197217E-02 1.47068553777E-02 1.48546617316E-02 1.50039535639E-02 1.51547458042E-02 1.53070535316E-02 1.54608919772E-02 1.56162765248E-02 1.57732227131E-02 1.59317462369E-02 1.60918629485E-02 1.62535888598E-02 1.64169401436E-02 1.65819331350E-02 1.67485843336E-02 1.69169104046E-02 1.70869281807E-02 1.72586546639E-02 1.74321070269E-02 1.76073026151E-02 1.77842589483E-02 1.79629937222E-02 1.81435248105E-02 1.83258702663E-02 1.85100483244E-02 1.86960774028E-02 1.88839761045E-02 1.90737632196E-02 1.92654577269E-02 1.94590787960E-02 1.96546457892E-02 1.98521782634E-02 2.00516959719E-02 2.02532188667E-02 2.04567671003E-02 2.06623610277E-02 2.08700212084E-02 2.10797684086E-02 2.12916236032E-02 2.15056079779E-02 2.17217429313E-02 2.19400500771E-02 2.21605512462E-02 2.23832684889E-02 2.26082240771E-02 2.28354405066E-02 2.30649404991E-02 2.32967470049E-02 2.35308832048E-02 2.37673725127E-02 2.40062385776E-02 2.42475052864E-02 2.44911967659E-02 2.47373373855E-02 2.49859517594E-02 2.52370647493E-02 2.54907014668E-02 2.57468872756E-02 2.60056477946E-02 2.62670089001E-02 2.65309967283E-02 2.67976376784E-02 2.70669584145E-02 2.73389858690E-02 2.76137472449E-02 2.78912700186E-02 2.81715819424E-02 2.84547110480E-02 2.87406856483E-02 2.90295343412E-02 2.93212860117E-02 2.96159698353E-02 2.99136152805E-02 3.02142521121E-02 3.05179103942E-02 3.08246204927E-02 3.11344130790E-02 3.14473191325E-02 3.17633699441E-02 3.20825971192E-02 3.24050325807E-02 3.27307085725E-02 3.30596576625E-02 3.33919127457E-02 3.37275070481E-02 3.40664741293E-02 3.44088478862E-02 3.47546625566E-02 3.51039527223E-02 3.54567533125E-02 3.58130996075E-02 3.61730272424E-02 3.65365722101E-02 3.69037708655E-02 3.72746599287E-02 3.76492764890E-02 3.80276580083E-02 3.84098423251E-02 3.87958676582E-02 3.91857726103E-02 3.95795961724E-02 3.99773777270E-02 4.03791570528E-02 4.07849743279E-02 4.11948701344E-02 4.16088854623E-02 4.20270617133E-02 4.24494407056E-02 4.28760646773E-02 4.33069762913E-02 4.37422186389E-02 4.41818352448E-02 4.46258700711E-02 4.50743675216E-02 4.55273724464E-02 4.59849301464E-02 4.64470863778E-02 4.69138873564E-02 4.73853797629E-02 4.78616107469E-02 4.83426279318E-02 4.88284794198E-02 4.93192137965E-02 4.98148801356E-02 5.03155280042E-02 5.08212074676E-02 5.13319690940E-02 5.18478639602E-02 5.23689436560E-02 5.28952602897E-02 5.34268664936E-02 5.39638154286E-02 5.45061607902E-02 5.50539568132E-02 5.56072582779E-02 5.61661205147E-02 5.67305994103E-02 5.73007514132E-02 5.78766335389E-02 5.84583033762E-02 5.90458190926E-02 5.96392394401E-02 6.02386237613E-02 6.08440319950E-02 6.14555246826E-02 6.20731629739E-02 6.26970086333E-02 6.33271240457E-02 6.39635722233E-02 6.46064168115E-02 6.52557220951E-02 6.59115530054E-02 6.65739751259E-02 6.72430546993E-02 6.79188586343E-02 6.86014545118E-02 6.92909105918E-02 6.99872958207E-02 7.06906798374E-02 7.14011329811E-02 7.21187262976E-02 7.28435315467E-02 7.35756212098E-02 7.43150684963E-02 7.50619473515E-02 7.58163324641E-02 7.65782992731E-02 7.73479239758E-02 7.81252835353E-02 7.89104556884E-02 7.97035189527E-02 8.05045526354E-02 8.13136368404E-02 8.21308524769E-02 8.29562812670E-02 8.37900057545E-02 8.46321093123E-02 8.54826761515E-02 8.63417913297E-02 8.72095407589E-02 8.80860112148E-02 8.89712903453E-02 8.98654666790E-02 9.07686296342E-02 9.16808695280E-02 9.26022775852E-02 9.35329459473E-02 9.44729676820E-02 9.54224367921E-02 9.63814482254E-02 9.73500978839E-02 9.83284826333E-02 9.93167003129E-02 1.00314849745E-01 1.01323030746E-01 1.02341344135E-01 1.03369891743E-01 1.04408776426E-01 1.05458102075E-01 1.06517973621E-01 1.07588497053E-01 1.08669779425E-01 1.09761928865E-01 1.10865054590E-01 1.11979266912E-01 1.13104677254E-01 1.14241398159E-01 1.15389543298E-01 1.16549227488E-01 1.17720566698E-01 1.18903678063E-01 1.20098679894E-01 1.21305691694E-01 1.22524834163E-01 1.23756229219E-01 1.25000000000E-01 1.26256270886E-01 1.27525167503E-01 1.28806816744E-01 1.30101346774E-01 1.31408887047E-01 1.32729568318E-01 1.34063522657E-01 1.35410883459E-01 1.36771785463E-01 1.38146364759E-01 1.39534758807E-01 1.40937106447E-01 1.42353547916E-01 1.43784224857E-01 1.45229280341E-01 1.46688858874E-01 1.48163106415E-01 1.49652170390E-01 1.51156199707E-01 1.52675344770E-01 1.54209757495E-01 1.55759591323E-01 1.57325001241E-01 1.58906143790E-01 1.60503177086E-01 1.62116260833E-01 1.63745556342E-01 1.65391226542E-01 1.67053436003E-01 1.68732350947E-01 1.70428139267E-01 1.72140970542E-01 1.73871016058E-01 1.75618448820E-01 1.77383443574E-01 1.79166176820E-01 1.80966826833E-01 1.82785573679E-01 1.84622599235E-01 1.86478087205E-01 1.88352223139E-01 1.90245194452E-01 1.92157190444E-01 1.94088402314E-01 1.96039023186E-01 1.98009248124E-01 1.99999274152E-01 2.02009300274E-01 2.04039527494E-01 2.06090158838E-01 2.08161399368E-01 2.10253456212E-01 2.12366538577E-01 2.14500857773E-01 2.16656627233E-01 2.18834062537E-01 2.21033381429E-01 2.23254803844E-01 2.25498551925E-01 2.27764850049E-01 2.30053924848E-01 2.32366005231E-01 2.34701322408E-01 2.37060109913E-01 2.39442603627E-01 2.41849041800E-01 2.44279665079E-01 2.46734716529E-01 2.49214441655E-01 2.51719088434E-01 2.54248907331E-01 2.56804151330E-01 2.59385075959E-01 2.61991939312E-01 2.64625002077E-01 2.67284527562E-01 2.69970781723E-01 2.72684033187E-01 2.75424553282E-01 2.78192616062E-01 2.80988498335E-01 2.83812479692E-01 2.86664842533E-01 2.89545872098E-01 2.92455856491E-01 2.95395086713E-01 2.98363856691E-01 3.01362463302E-01 3.04391206411E-01 3.07450388895E-01 3.10540316673E-01 3.13661298742E-01 3.16813647202E-01 3.19997677291E-01 3.23213707414E-01 3.26462059178E-01 3.29743057419E-01 3.33057030241E-01 3.36404309044E-01 3.39785228557E-01 3.43200126877E-01 3.46649345496E-01 3.50133229337E-01 3.53652126794E-01 3.57206389758E-01 3.60796373658E-01 3.64422437497E-01 3.68084943883E-01 3.71784259070E-01 3.75520752993E-01 3.79294799304E-01 3.83106775412E-01 3.86957062516E-01 3.90846045648E-01 3.94774113711E-01 3.98741659515E-01 4.02749079816E-01 4.06796775361E-01 4.10885150923E-01 4.15014615342E-01 4.19185581569E-01 4.23398466703E-01 4.27653692036E-01 4.31951683095E-01 4.36292869683E-01 4.40677685921E-01 4.45106570294E-01 4.49579965696E-01 4.54098319469E-01 4.58662083452E-01 4.63271714026E-01 4.67927672158E-01 4.72630423446E-01 4.77380438171E-01 4.82178191337E-01 4.87024162724E-01 4.91918836934E-01 4.96862703437E-01 5.01856256624E-01 5.06899995856E-01 5.11994425509E-01 5.17140055031E-01 5.22337398990E-01 5.27586977125E-01 5.32889314396E-01 5.38244941043E-01 5.43654392633E-01 5.49118210115E-01 5.54636939875E-01 5.60211133792E-01 5.65841349289E-01 5.71528149393E-01 5.77272102787E-01 5.83073783874E-01 5.88933772824E-01 5.94852655642E-01 6.00831024222E-01 6.06869476405E-01 6.12968616041E-01 6.19129053049E-01 6.25351403479E-01 6.31636289570E-01 6.37984339817E-01 6.44396189029E-01 6.50872478397E-01 6.57413855556E-01 6.64020974648E-01 6.70694496390E-01 6.77435088141E-01 6.84243423966E-01 6.91120184703E-01 6.98066058035E-01 7.05081738554E-01 7.12167927834E-01 7.19325334501E-01 7.26554674300E-01 7.33856670173E-01 7.41232052324E-01 7.48681558298E-01 7.56205933052E-01 7.63805929029E-01 7.71482306235E-01 7.79235832316E-01 7.87067282628E-01 7.94977440325E-01 8.02967096429E-01 8.11037049911E-01 8.19188107774E-01 8.27421085130E-01 8.35736805285E-01 8.44136099816E-01 8.52619808661E-01 8.61188780198E-01 8.69843871330E-01 8.78585947574E-01 8.87415883145E-01 8.96334561043E-01 9.05342873145E-01 9.14441720289E-01 9.23632012366E-01 9.32914668415E-01 9.42290616708E-01 9.51760794847E-01 9.61326149860E-01 9.70987638288E-01 9.80746226290E-01 9.90602889731E-01 1.00055861429E+00 1.01061439554E+00 1.02077123907E+00 1.03103016058E+00 1.04139218596E+00 1.05185835143E+00 1.06242970361E+00 1.07310729965E+00 1.08389220731E+00 1.09478550509E+00 1.10578828234E+00 1.11690163934E+00 1.12812668743E+00 1.13946454913E+00 1.15091635824E+00 1.16248325994E+00 1.17416641093E+00 1.18596697954E+00 1.19788614585E+00 1.20992510176E+00 1.22208505119E+00 1.23436721015E+00 1.24677280685E+00 1.25930308188E+00 1.27195928826E+00 1.28474269163E+00 1.29765457034E+00 1.31069621559E+00 1.32386893155E+00 1.33717403551E+00 1.35061285799E+00 1.36418674288E+00 1.37789704758E+00 1.39174514313E+00 1.40573241436E+00 1.41986026000E+00 1.43413009285E+00 1.44854333990E+00 1.46310144250E+00 1.47780585646E+00 1.49265805223E+00 1.50765951506E+00 1.52281174509E+00 1.53811625756E+00 1.55357458295E+00 1.56918826708E+00 1.58495887135E+00 1.60088797283E+00 1.61697716444E+00 1.63322805512E+00 1.64964226996E+00 1.66622145040E+00 1.68296725438E+00 1.69988135648E+00 1.71696544813E+00 1.73422123777E+00 1.75165045097E+00 1.76925483067E+00 1.78703613733E+00 1.80499614910E+00 1.82313666199E+00 1.84145949006E+00 1.85996646561E+00 1.87865943936E+00 1.89754028062E+00 1.91661087749E+00 1.93587313704E+00 1.95532898552E+00 1.97498036853E+00 1.99482925122E+00 2.01487761850E+00 2.03512747522E+00 2.05558084639E+00 2.07623977735E+00 2.09710633402E+00 2.11818260307E+00 2.13947069214E+00 2.16097273007E+00 2.18269086707E+00 2.20462727498E+00 2.22678414745E+00 2.24916370019E+00 2.27176817118E+00 2.29459982088E+00 2.31766093247E+00 2.34095381208E+00 2.36448078903E+00 2.38824421603E+00 2.41224646944E+00 2.43648994950E+00 2.46097708060E+00 2.48571031145E+00 2.51069211540E+00 2.53592499066E+00 2.56141146052E+00 2.58715407367E+00 2.61315540439E+00 2.63941805282E+00 2.66594464525E+00 2.69273783438E+00 2.71980029952E+00 2.74713474697E+00 2.77474391018E+00 2.80263055009E+00 2.83079745540E+00 2.85924744281E+00 2.88798335734E+00 2.91700807262E+00 2.94632449113E+00 2.97593554455E+00 3.00584419401E+00 3.03605343039E+00 3.06656627464E+00 3.09738577807E+00 3.12851502267E+00 3.15995712137E+00 3.19171521842E+00 3.22379248965E+00 3.25619214281E+00 3.28891741791E+00 3.32197158748E+00 3.35535795699E+00 3.38907986508E+00 3.42314068399E+00 3.45754381981E+00 3.49229271290E+00 3.52739083818E+00 3.56284170547E+00 3.59864885991E+00 3.63481588222E+00 3.67134638916E+00 3.70824403380E+00 3.74551250592E+00 3.78315553243E+00 3.82117687763E+00 3.85958034371E+00 3.89836977104E+00 3.93754903859E+00 3.97712206433E+00 4.01709280559E+00 4.05746525948E+00 4.09824346328E+00 4.13943149484E+00 4.18103347299E+00 4.22305355798E+00 4.26549595184E+00 4.30836489886E+00 4.35166468595E+00 4.39539964314E+00 4.43957414395E+00 4.48419260588E+00 4.52925949081E+00 4.57477930546E+00 4.62075660185E+00 4.66719597776E+00 4.71410207715E+00 4.76147959067E+00 4.80933325613E+00 4.85766785892E+00 4.90648823254E+00 4.95579925907E+00 5.00560586966E+00 5.05591304501E+00 5.10672581587E+00 5.15804926358E+00 5.20988852050E+00 5.26224877062E+00 5.31513525001E+00 5.36855324735E+00 5.42250810448E+00 5.47700521695E+00 5.53205003450E+00 5.58764806166E+00 5.64380485829E+00 5.70052604011E+00 5.75781727928E+00 5.81568430497E+00 5.87413290395E+00 5.93316892111E+00 5.99279826010E+00 6.05302688392E+00 6.11386081547E+00 6.17530613819E+00 6.23736899668E+00 6.30005559726E+00 6.36337220865E+00 6.42732516257E+00 6.49192085435E+00 6.55716574364E+00 6.62306635496E+00 6.68962927844E+00 6.75686117042E+00 6.82476875414E+00 6.89335882043E+00 6.96263822835E+00 7.03261390589E+00 7.10329285068E+00 7.17468213068E+00 7.24678888487E+00 7.31962032399E+00 7.39318373124E+00 7.46748646302E+00 7.54253594967E+00 7.61833969620E+00 7.69490528305E+00 7.77224036685E+00 7.85035268115E+00 7.92925003727E+00 8.00894032499E+00 8.08943151343E+00 8.17073165175E+00 8.25284887005E+00 8.33579138012E+00 8.41956747626E+00 8.50418553618E+00 8.58965402173E+00 8.67598147984E+00 8.76317654334E+00 8.85124793178E+00 8.94020445240E+00 9.03005500092E+00 9.12080856245E+00 9.21247421245E+00 9.30506111754E+00 9.39857853650E+00 9.49303582115E+00 9.58844241729E+00 9.68480786566E+00 9.78214180289E+00 9.88045396245E+00 9.97975417564E+00 1.00800523726E+01 1.01813585831E+01 1.02836829380E+01 1.03870356698E+01 1.04914271138E+01 1.05968677092E+01 1.07033680003E+01 1.08109386370E+01 1.09195903767E+01 1.10293340845E+01 1.11401807348E+01 1.12521414126E+01 1.13652273138E+01 1.14794497473E+01 1.15948201353E+01 1.17113500149E+01 1.18290510394E+01 1.19479349788E+01 1.20680137216E+01 1.21892992759E+01 1.23118037702E+01 1.24355394552E+01 1.25605187045E+01 1.26867540162E+01 1.28142580138E+01 1.29430434479E+01 1.30731231971E+01 1.32045102696E+01 1.33372178041E+01 1.34712590714E+01 1.36066474759E+01 1.37433965565E+01 1.38815199882E+01 1.40210315835E+01 1.41619452936E+01 1.43042752100E+01 1.44480355659E+01 1.45932407374E+01 1.47399052451E+01 1.48880437556E+01 1.50376710829E+01 1.51888021898E+01 1.53414521897E+01 1.54956363475E+01 1.56513700818E+01 1.58086689663E+01 1.59675487308E+01 1.61280252634E+01 1.62901146121E+01 1.64538329857E+01 1.66191967564E+01 1.67862224606E+01 1.69549268011E+01 1.71253266483E+01 1.72974390425E+01 1.74712811950E+01 1.76468704902E+01 1.78242244871E+01 1.80033609214E+01 1.81842977067E+01 1.83670529370E+01 1.85516448878E+01 1.87380920186E+01 1.89264129743E+01 1.91166265870E+01 1.93087518782E+01 1.95028080608E+01 1.96988145404E+01 1.98967909179E+01 2.00967569911E+01 2.02987327567E+01 2.05027384125E+01 2.07087943592E+01 2.09169212026E+01 2.11271397556E+01 2.13394710402E+01 2.15539362896E+01 2.17705569506E+01 2.19893546855E+01 2.22103513742E+01 2.24335691165E+01 2.26590302344E+01 2.28867572742E+01 2.31167730088E+01 2.33491004400E+01 2.35837628007E+01 2.38207835573E+01 2.40601864122E+01 2.43019953057E+01 2.45462344190E+01 2.47929281762E+01 2.50421012468E+01 2.52937785485E+01 2.55479852491E+01 2.58047467695E+01 2.60640887861E+01 2.63260372333E+01 2.65906183062E+01 2.68578584630E+01 2.71277844281E+01 2.74004231942E+01 2.76758020255E+01 2.79539484601E+01 2.82348903128E+01 2.85186556780E+01 2.88052729326E+01 2.90947707385E+01 2.93871780457E+01 2.96825240951E+01 2.99808384218E+01 3.02821508572E+01 3.05864915330E+01 3.08938908835E+01 3.12043796487E+01 3.15179888779E+01 3.18347499323E+01 3.21546944882E+01 3.24778545404E+01 3.28042624050E+01 3.31339507233E+01 3.34669524642E+01 3.38033009283E+01 3.41430297506E+01 3.44861729043E+01 3.48327647041E+01 3.51828398094E+01 3.55364332280E+01 3.58935803195E+01 3.62543167990E+01 3.66186787403E+01 3.69867025801E+01 3.73584251209E+01 3.77338835353E+01 3.81131153696E+01 3.84961585472E+01 3.88830513727E+01 3.92738325357E+01 3.96685411147E+01 4.00672165809E+01 4.04698988022E+01 4.08766280470E+01 4.12874449887E+01 4.17023907093E+01 4.21215067038E+01 4.25448348840E+01 4.29724175831E+01 4.34042975598E+01 4.38405180025E+01 4.42811225335E+01 4.47261552136E+01 4.51756605465E+01 4.56296834832E+01 4.60882694262E+01 4.65514642345E+01 4.70193142281E+01 4.74918661923E+01 4.79691673826E+01 4.84512655297E+01 4.89382088437E+01 4.94300460194E+01 4.99268262409E+01 5.04285991866E+01 5.09354150342E+01 5.14473244658E+01 5.19643786727E+01 5.24866293608E+01 5.30141287556E+01 5.35469296074E+01 5.40850851968E+01 5.46286493398E+01 5.51776763932E+01 5.57322212603E+01 5.62923393960E+01 5.68580868124E+01 5.74295200850E+01 5.80066963574E+01 5.85896733478E+01 5.91785093544E+01 5.97732632612E+01 6.03739945441E+01 6.09807632768E+01 6.15936301367E+01 6.22126564109E+01 6.28379040025E+01 6.34694354370E+01 6.41073138679E+01 6.47516030835E+01 6.54023675135E+01 6.60596722347E+01 6.67235829782E+01 6.73941661356E+01 6.80714887657E+01 6.87556186015E+01 6.94466240564E+01 7.01445742316E+01 7.08495389227E+01 7.15615886267E+01 7.22807945492E+01 7.30072286114E+01 7.37409634573E+01 7.44820724610E+01 7.52306297340E+01 7.59867101327E+01 7.67503892657E+01 7.75217435016E+01 7.83008499764E+01 7.90877866015E+01 7.98826320712E+01 8.06854658706E+01 8.14963682839E+01 8.23154204019E+01 8.31427041305E+01 8.39783021989E+01 8.48222981674E+01 8.56747764365E+01 8.65358222546E+01 8.74055217270E+01 8.82839618244E+01 8.91712303916E+01 9.00674161561E+01 9.09726087374E+01 9.18868986552E+01 9.28103773396E+01 9.37431371390E+01 9.46852713302E+01 9.56368741275E+01 9.65980406919E+01 9.75688671409E+01 9.85494505578E+01 9.95398890020E+01 3.09844022083E-06 3.12958006275E-06 3.16103286529E-06 3.19280177374E-06 3.22488996503E-06 3.25730064801E-06 3.29003706377E-06 3.32310248597E-06 3.35650022119E-06 3.39023360923E-06 3.42430602346E-06 3.45872087114E-06 3.49348159380E-06 3.52859166752E-06 3.56405460335E-06 3.59987394761E-06 3.63605328227E-06 3.67259622528E-06 3.70950643098E-06 3.74678759041E-06 3.78444343172E-06 3.82247772053E-06 3.86089426030E-06 3.89969689271E-06 3.93888949806E-06 3.97847599564E-06 4.01846034413E-06 4.05884654201E-06 4.09963862793E-06 4.14084068112E-06 4.18245682184E-06 4.22449121172E-06 4.26694805424E-06 4.30983159513E-06 4.35314612276E-06 4.39689596864E-06 4.44108550778E-06 4.48571915916E-06 4.53080138621E-06 4.57633669716E-06 4.62232964560E-06 4.66878483086E-06 4.71570689849E-06 4.76310054074E-06 4.81097049701E-06 4.85932155435E-06 4.90815854788E-06 4.95748636136E-06 5.00730992761E-06 5.05763422903E-06 5.10846429808E-06 5.15980521782E-06 5.21166212238E-06 5.26404019750E-06 5.31694468102E-06 5.37038086344E-06 5.42435408842E-06 5.47886975334E-06 5.53393330979E-06 5.58955026419E-06 5.64572617827E-06 5.70246666967E-06 5.75977741249E-06 5.81766413785E-06 5.87613263448E-06 5.93518874926E-06 5.99483838787E-06 6.05508751531E-06 6.11594215655E-06 6.17740839710E-06 6.23949238364E-06 6.30220032461E-06 6.36553849087E-06 6.42951321629E-06 6.49413089838E-06 6.55939799898E-06 6.62532104484E-06 6.69190662832E-06 6.75916140805E-06 6.82709210955E-06 6.89570552595E-06 6.96500851865E-06 7.03500801801E-06 7.10571102402E-06 7.17712460707E-06 7.24925590855E-06 7.32211214167E-06 7.39570059210E-06 7.47002861876E-06 7.54510365450E-06 7.62093320689E-06 7.69752485896E-06 7.77488626993E-06 7.85302517600E-06 7.93194939114E-06 8.01166680782E-06 8.09218539786E-06 8.17351321319E-06 8.25565838664E-06 8.33862913282E-06 8.42243374886E-06 8.50708061529E-06 8.59257819687E-06 8.67893504343E-06 8.76615979073E-06 8.85426116132E-06 8.94324796539E-06 9.03312910172E-06 9.12391355849E-06 9.21561041421E-06 9.30822883866E-06 9.40177809374E-06 9.49626753447E-06 9.59170660987E-06 9.68810486392E-06 9.78547193653E-06 9.88381756449E-06 9.98315158244E-06 1.00834839239E-05 1.01848246221E-05 1.02871838113E-05 1.03905717274E-05 1.04949987094E-05 1.06004751999E-05 1.07070117469E-05 1.08146190039E-05 1.09233077318E-05 1.10330887997E-05 1.11439731855E-05 1.12559719780E-05 1.13690963771E-05 1.14833576953E-05 1.15987673588E-05 1.17153369088E-05 1.18330780021E-05 1.19520024132E-05 1.20721220344E-05 1.21934488779E-05 1.23159950765E-05 1.24397728848E-05 1.25647946808E-05 1.26910729667E-05 1.28186203705E-05 1.29474496470E-05 1.30775736793E-05 1.32090054798E-05 1.33417581919E-05 1.34758450909E-05 1.36112795857E-05 1.37480752198E-05 1.38862456728E-05 1.40258047620E-05 1.41667664433E-05 1.43091448131E-05 1.44529541093E-05 1.45982087130E-05 1.47449231497E-05 1.48931120910E-05 1.50427903559E-05 1.51939729124E-05 1.53466748788E-05 1.55009115256E-05 1.56566982763E-05 1.58140507100E-05 1.59729845619E-05 1.61335157256E-05 1.62956602543E-05 1.64594343626E-05 1.66248544281E-05 1.67919369928E-05 1.69606987653E-05 1.71311566217E-05 1.73033276081E-05 1.74772289417E-05 1.76528780127E-05 1.78302923862E-05 1.80094898039E-05 1.81904881855E-05 1.83733056311E-05 1.85579604226E-05 1.87444710256E-05 1.89328560913E-05 1.91231344584E-05 1.93153251549E-05 1.95094474000E-05 1.97055206061E-05 1.99035643806E-05 2.01035985282E-05 2.03056430524E-05 2.05097181579E-05 2.07158442522E-05 2.09240419482E-05 2.11343320659E-05 2.13467356344E-05 2.15612738942E-05 2.17779682994E-05 2.19968405195E-05 2.22179124421E-05 2.24412061744E-05 2.26667440460E-05 2.28945486109E-05 2.31246426498E-05 2.33570491722E-05 2.35917914189E-05 2.38288928645E-05 2.40683772192E-05 2.43102684317E-05 2.45545906913E-05 2.48013684305E-05 2.50506263271E-05 2.53023893073E-05 2.55566825474E-05 2.58135314771E-05 2.60729617815E-05 2.63349994038E-05 2.65996705480E-05 2.68670016814E-05 2.71370195373E-05 2.74097511178E-05 2.76852236963E-05 2.79634648202E-05 2.82445023139E-05 2.85283642814E-05 2.88150791090E-05 2.91046754686E-05 2.93971823200E-05 2.96926289141E-05 2.99910447959E-05 3.02924598071E-05 3.05969040896E-05 3.09044080879E-05 3.12150025528E-05 3.15287185440E-05 3.18455874334E-05 3.21656409079E-05 3.24889109734E-05 3.28154299571E-05 3.31452305111E-05 3.34783456158E-05 3.38148085829E-05 3.41546530591E-05 3.44979130291E-05 3.48446228191E-05 3.51948171004E-05 3.55485308927E-05 3.59057995678E-05 3.62666588527E-05 3.66311448338E-05 3.69992939599E-05 3.73711430462E-05 3.77467292779E-05 3.81260902140E-05 3.85092637909E-05 3.88962883263E-05 3.92872025230E-05 3.96820454726E-05 4.00808566598E-05 4.04836759661E-05 4.08905436738E-05 4.13015004699E-05 4.17165874504E-05 4.21358461245E-05 4.25593184182E-05 4.29870466793E-05 4.34190736809E-05 4.38554426261E-05 4.42961971520E-05 4.47413813346E-05 4.51910396926E-05 4.56452171922E-05 4.61039592516E-05 4.65673117453E-05 4.70353210090E-05 4.75080338440E-05 4.79854975219E-05 4.84677597897E-05 4.89548688737E-05 4.94468734855E-05 4.99438228258E-05 5.04457665900E-05 5.09527549730E-05 5.14648386738E-05 5.19820689015E-05 5.25044973793E-05 5.30321763506E-05 5.35651585838E-05 5.41034973775E-05 5.46472465659E-05 5.51964605246E-05 5.57511941753E-05 5.63115029919E-05 5.68774430058E-05 5.74490708113E-05 5.80264435718E-05 5.86096190250E-05 5.91986554889E-05 5.97936118677E-05 6.03945476576E-05 6.10015229525E-05 6.16145984506E-05 6.22338354598E-05 6.28592959045E-05 6.34910423311E-05 6.41291379149E-05 6.47736464659E-05 6.54246324355E-05 6.60821609229E-05 6.67462976815E-05 6.74171091254E-05 6.80946623365E-05 6.87790250705E-05 6.94702657644E-05 7.01684535427E-05 7.08736582248E-05 7.15859503318E-05 7.23054010935E-05 7.30320824556E-05 7.37660670868E-05 7.45074283862E-05 7.52562404905E-05 7.60125782815E-05 7.67765173938E-05 7.75481342217E-05 7.83275059277E-05 7.91147104496E-05 7.99098265084E-05 8.07129336165E-05 8.15241120852E-05 8.23434430330E-05 8.31710083938E-05 8.40068909247E-05 8.48511742147E-05 8.57039426928E-05 8.65652816367E-05 8.74352771808E-05 8.83140163255E-05 8.92015869455E-05 9.00980777985E-05 9.10035785343E-05 9.19181797038E-05 9.28419727679E-05 9.37750501067E-05 9.47175050286E-05 9.56694317799E-05 9.66309255541E-05 9.76020825014E-05 9.85829997383E-05 9.95737753574E-05 1.00574508437E-04 1.01585299051E-04 1.02606248280E-04 1.03637458219E-04 1.04679031990E-04 1.05731073752E-04 1.06793688709E-04 1.07866983124E-04 1.08951064327E-04 1.10046040728E-04 1.11152021824E-04 1.12269118215E-04 1.13397441612E-04 1.14537104847E-04 1.15688221888E-04 1.16850907848E-04 1.18025278995E-04 1.19211452769E-04 1.20409547788E-04 1.21619683862E-04 1.22841982005E-04 1.24076564450E-04 1.25323554654E-04 1.26583077317E-04 1.27855258394E-04 1.29140225104E-04 1.30438105943E-04 1.31749030702E-04 1.33073130474E-04 1.34410537670E-04 1.35761386031E-04 1.37125810644E-04 1.38503947953E-04 1.39895935772E-04 1.41301913301E-04 1.42722021139E-04 1.44156401298E-04 1.45605197217E-04 1.47068553777E-04 1.48546617316E-04 1.50039535639E-04 1.51547458042E-04 1.53070535316E-04 1.54608919772E-04 1.56162765248E-04 1.57732227131E-04 1.59317462369E-04 1.60918629485E-04 1.62535888598E-04 1.64169401436E-04 1.65819331350E-04 1.67485843336E-04 1.69169104046E-04 1.70869281807E-04 1.72586546639E-04 1.74321070269E-04 1.76073026151E-04 1.77842589483E-04 1.79629937222E-04 1.81435248105E-04 1.83258702663E-04 1.85100483244E-04 1.86960774028E-04 1.88839761045E-04 1.90737632196E-04 1.92654577269E-04 1.94590787960E-04 1.96546457892E-04 1.98521782634E-04 2.00516959719E-04 2.02532188667E-04 2.04567671003E-04 2.06623610277E-04 2.08700212084E-04 2.10797684086E-04 2.12916236032E-04 2.15056079779E-04 2.17217429313E-04 2.19400500771E-04 2.21605512462E-04 2.23832684889E-04 2.26082240771E-04 2.28354405066E-04 2.30649404991E-04 2.32967470049E-04 2.35308832048E-04 2.37673725127E-04 2.40062385776E-04 2.42475052864E-04 2.44911967659E-04 2.47373373855E-04 2.49859517594E-04 2.52370647493E-04 2.54907014668E-04 2.57468872756E-04 2.60056477946E-04 2.62670089001E-04 2.65309967283E-04 2.67976376784E-04 2.70669584145E-04 2.73389858690E-04 2.76137472449E-04 2.78912700186E-04 2.81715819424E-04 2.84547110480E-04 2.87406856483E-04 2.90295343412E-04 2.93212860117E-04 2.96159698353E-04 2.99136152805E-04 3.02142521121E-04 3.05179103942E-04 3.08246204927E-04 3.11344130790E-04 3.14473191325E-04 3.17633699441E-04 3.20825971192E-04 3.24050325807E-04 3.27307085725E-04 3.30596576625E-04 3.33919127457E-04 3.37275070481E-04 3.40664741293E-04 3.44088478862E-04 3.47546625566E-04 3.51039527223E-04 3.54567533125E-04 3.58130996075E-04 3.61730272424E-04 3.65365722101E-04 3.69037708655E-04 3.72746599287E-04 3.76492764890E-04 3.80276580083E-04 3.84098423251E-04 3.87958676582E-04 3.91857726103E-04 3.95795961724E-04 3.99773777270E-04 4.03791570528E-04 4.07849743279E-04 4.11948701344E-04 4.16088854623E-04 4.20270617133E-04 4.24494407056E-04 4.28760646773E-04 4.33069762913E-04 4.37422186389E-04 4.41818352448E-04 4.46258700711E-04 4.50743675216E-04 4.55273724464E-04 4.59849301464E-04 4.64470863778E-04 4.69138873564E-04 4.73853797629E-04 4.78616107469E-04 4.83426279318E-04 4.88284794198E-04 4.93192137965E-04 4.98148801356E-04 5.03155280042E-04 5.08212074676E-04 5.13319690940E-04 5.18478639602E-04 5.23689436560E-04 5.28952602897E-04 5.34268664936E-04 5.39638154286E-04 5.45061607902E-04 5.50539568132E-04 5.56072582779E-04 5.61661205147E-04 5.67305994103E-04 5.73007514132E-04 5.78766335389E-04 5.84583033762E-04 5.90458190926E-04 5.96392394401E-04 6.02386237613E-04 6.08440319950E-04 6.14555246826E-04 6.20731629739E-04 6.26970086333E-04 6.33271240457E-04 6.39635722233E-04 6.46064168115E-04 6.52557220951E-04 6.59115530054E-04 6.65739751259E-04 6.72430546993E-04 6.79188586343E-04 6.86014545118E-04 6.92909105918E-04 6.99872958207E-04 7.06906798374E-04 7.14011329811E-04 7.21187262976E-04 7.28435315467E-04 7.35756212098E-04 7.43150684963E-04 7.50619473515E-04 7.58163324641E-04 7.65782992731E-04 7.73479239758E-04 7.81252835353E-04 7.89104556884E-04 7.97035189527E-04 8.05045526354E-04 8.13136368404E-04 8.21308524769E-04 8.29562812670E-04 8.37900057545E-04 8.46321093123E-04 8.54826761515E-04 8.63417913297E-04 8.72095407589E-04 8.80860112148E-04 8.89712903453E-04 8.98654666790E-04 9.07686296342E-04 9.16808695280E-04 9.26022775852E-04 9.35329459473E-04 9.44729676820E-04 9.54224367921E-04 9.63814482254E-04 9.73500978839E-04 9.83284826333E-04 9.93167003129E-04 1.00314849745E-03 1.01323030746E-03 1.02341344135E-03 1.03369891743E-03 1.04408776426E-03 1.05458102075E-03 1.06517973621E-03 1.07588497053E-03 1.08669779425E-03 1.09761928865E-03 1.10865054590E-03 1.11979266912E-03 1.13104677254E-03 1.14241398159E-03 1.15389543298E-03 1.16549227488E-03 1.17720566698E-03 1.18903678063E-03 1.20098679894E-03 1.21305691694E-03 1.22524834163E-03 1.23756229219E-03 1.25000000000E-03 1.26256270886E-03 1.27525167503E-03 1.28806816744E-03 1.30101346774E-03 1.31408887047E-03 1.32729568318E-03 1.34063522657E-03 1.35410883459E-03 1.36771785463E-03 1.38146364759E-03 1.39534758807E-03 1.40937106447E-03 1.42353547916E-03 1.43784224857E-03 1.45229280341E-03 1.46688858874E-03 1.48163106415E-03 1.49652170390E-03 1.51156199707E-03 1.52675344770E-03 1.54209757495E-03 1.55759591323E-03 1.57325001241E-03 1.58906143790E-03 1.60503177086E-03 1.62116260833E-03 1.63745556342E-03 1.65391226542E-03 1.67053436003E-03 1.68732350947E-03 1.70428139267E-03 1.72140970542E-03 1.73871016058E-03 1.75618448820E-03 1.77383443574E-03 1.79166176820E-03 1.80966826833E-03 1.82785573679E-03 1.84622599235E-03 1.86478087205E-03 1.88352223139E-03 1.90245194452E-03 1.92157190444E-03 1.94088402314E-03 1.96039023186E-03 1.98009248124E-03 1.99999274152E-03 2.02009300274E-03 2.04039527494E-03 2.06090158838E-03 2.08161399368E-03 2.10253456212E-03 2.12366538577E-03 2.14500857773E-03 2.16656627233E-03 2.18834062537E-03 2.21033381429E-03 2.23254803844E-03 2.25498551925E-03 2.27764850049E-03 2.30053924848E-03 2.32366005231E-03 2.34701322408E-03 2.37060109913E-03 2.39442603627E-03 2.41849041800E-03 2.44279665079E-03 2.46734716529E-03 2.49214441655E-03 2.51719088434E-03 2.54248907331E-03 2.56804151330E-03 2.59385075959E-03 2.61991939312E-03 2.64625002077E-03 2.67284527562E-03 2.69970781723E-03 2.72684033187E-03 2.75424553282E-03 2.78192616062E-03 2.80988498335E-03 2.83812479692E-03 2.86664842533E-03 2.89545872098E-03 2.92455856491E-03 2.95395086713E-03 2.98363856691E-03 3.01362463302E-03 3.04391206411E-03 3.07450388895E-03 3.10540316673E-03 3.13661298742E-03 3.16813647202E-03 3.19997677291E-03 3.23213707414E-03 3.26462059178E-03 3.29743057419E-03 3.33057030241E-03 3.36404309044E-03 3.39785228557E-03 3.43200126877E-03 3.46649345496E-03 3.50133229337E-03 3.53652126794E-03 3.57206389758E-03 3.60796373658E-03 3.64422437497E-03 3.68084943883E-03 3.71784259070E-03 3.75520752993E-03 3.79294799304E-03 3.83106775412E-03 3.86957062516E-03 3.90846045648E-03 3.94774113711E-03 3.98741659515E-03 4.02749079816E-03 4.06796775361E-03 4.10885150923E-03 4.15014615342E-03 4.19185581569E-03 4.23398466703E-03 4.27653692036E-03 4.31951683095E-03 4.36292869683E-03 4.40677685921E-03 4.45106570294E-03 4.49579965696E-03 4.54098319469E-03 4.58662083452E-03 4.63271714026E-03 4.67927672158E-03 4.72630423446E-03 4.77380438171E-03 4.82178191337E-03 4.87024162724E-03 4.91918836934E-03 4.96862703437E-03 5.01856256624E-03 5.06899995856E-03 5.11994425509E-03 5.17140055031E-03 5.22337398990E-03 5.27586977125E-03 5.32889314396E-03 5.38244941043E-03 5.43654392633E-03 5.49118210115E-03 5.54636939875E-03 5.60211133792E-03 5.65841349289E-03 5.71528149393E-03 5.77272102787E-03 5.83073783874E-03 5.88933772824E-03 5.94852655642E-03 6.00831024222E-03 6.06869476405E-03 6.12968616041E-03 6.19129053049E-03 6.25351403479E-03 6.31636289570E-03 6.37984339817E-03 6.44396189029E-03 6.50872478397E-03 6.57413855556E-03 6.64020974648E-03 6.70694496390E-03 6.77435088141E-03 6.84243423966E-03 6.91120184703E-03 6.98066058035E-03 7.05081738554E-03 7.12167927834E-03 7.19325334501E-03 7.26554674300E-03 7.33856670173E-03 7.41232052324E-03 7.48681558298E-03 7.56205933052E-03 7.63805929029E-03 7.71482306235E-03 7.79235832316E-03 7.87067282628E-03 7.94977440325E-03 8.02967096429E-03 8.11037049911E-03 8.19188107774E-03 8.27421085130E-03 8.35736805285E-03 8.44136099816E-03 8.52619808661E-03 8.61188780198E-03 8.69843871330E-03 8.78585947574E-03 8.87415883145E-03 8.96334561043E-03 9.05342873145E-03 9.14441720289E-03 9.23632012366E-03 9.32914668415E-03 9.42290616708E-03 9.51760794847E-03 9.61326149860E-03 9.70987638288E-03 9.80746226290E-03 9.90602889731E-03 1.00055861429E-02 1.01061439554E-02 1.02077123907E-02 1.03103016058E-02 1.04139218596E-02 1.05185835143E-02 1.06242970361E-02 1.07310729965E-02 1.08389220731E-02 1.09478550509E-02 1.10578828234E-02 1.11690163934E-02 1.12812668743E-02 1.13946454913E-02 1.15091635824E-02 1.16248325994E-02 1.17416641093E-02 1.18596697954E-02 1.19788614585E-02 1.20992510176E-02 1.22208505119E-02 1.23436721015E-02 1.24677280685E-02 1.25930308188E-02 1.27195928826E-02 1.28474269163E-02 1.29765457034E-02 1.31069621559E-02 1.32386893155E-02 1.33717403551E-02 1.35061285799E-02 1.36418674288E-02 1.37789704758E-02 1.39174514313E-02 1.40573241436E-02 1.41986026000E-02 1.43413009285E-02 1.44854333990E-02 1.46310144250E-02 1.47780585646E-02 1.49265805223E-02 1.50765951506E-02 1.52281174509E-02 1.53811625756E-02 1.55357458295E-02 1.56918826708E-02 1.58495887135E-02 1.60088797283E-02 1.61697716444E-02 1.63322805512E-02 1.64964226996E-02 1.66622145040E-02 1.68296725438E-02 1.69988135648E-02 1.71696544813E-02 1.73422123777E-02 1.75165045097E-02 1.76925483067E-02 1.78703613733E-02 1.80499614910E-02 1.82313666199E-02 1.84145949006E-02 1.85996646561E-02 1.87865943936E-02 1.89754028062E-02 1.91661087749E-02 1.93587313704E-02 1.95532898552E-02 1.97498036853E-02 1.99482925122E-02 2.01487761850E-02 2.03512747522E-02 2.05558084639E-02 2.07623977735E-02 2.09710633402E-02 2.11818260307E-02 2.13947069214E-02 2.16097273007E-02 2.18269086707E-02 2.20462727498E-02 2.22678414745E-02 2.24916370019E-02 2.27176817118E-02 2.29459982088E-02 2.31766093247E-02 2.34095381208E-02 2.36448078903E-02 2.38824421603E-02 2.41224646944E-02 2.43648994950E-02 2.46097708060E-02 2.48571031145E-02 2.51069211540E-02 2.53592499066E-02 2.56141146052E-02 2.58715407367E-02 2.61315540439E-02 2.63941805282E-02 2.66594464525E-02 2.69273783438E-02 2.71980029952E-02 2.74713474697E-02 2.77474391018E-02 2.80263055009E-02 2.83079745540E-02 2.85924744281E-02 2.88798335734E-02 2.91700807262E-02 2.94632449113E-02 2.97593554455E-02 3.00584419401E-02 3.03605343039E-02 3.06656627464E-02 3.09738577807E-02 3.12851502267E-02 3.15995712137E-02 3.19171521842E-02 3.22379248965E-02 3.25619214281E-02 3.28891741791E-02 3.32197158748E-02 3.35535795699E-02 3.38907986508E-02 3.42314068399E-02 3.45754381981E-02 3.49229271290E-02 3.52739083818E-02 3.56284170547E-02 3.59864885991E-02 3.63481588222E-02 3.67134638916E-02 3.70824403380E-02 3.74551250592E-02 3.78315553243E-02 3.82117687763E-02 3.85958034371E-02 3.89836977104E-02 3.93754903859E-02 3.97712206433E-02 4.01709280559E-02 4.05746525948E-02 4.09824346328E-02 4.13943149484E-02 4.18103347299E-02 4.22305355798E-02 4.26549595184E-02 4.30836489886E-02 4.35166468595E-02 4.39539964314E-02 4.43957414395E-02 4.48419260588E-02 4.52925949081E-02 4.57477930546E-02 4.62075660185E-02 4.66719597776E-02 4.71410207715E-02 4.76147959067E-02 4.80933325613E-02 4.85766785892E-02 4.90648823254E-02 4.95579925907E-02 5.00560586966E-02 5.05591304501E-02 5.10672581587E-02 5.15804926358E-02 5.20988852050E-02 5.26224877062E-02 5.31513525001E-02 5.36855324735E-02 5.42250810448E-02 5.47700521695E-02 5.53205003450E-02 5.58764806166E-02 5.64380485829E-02 5.70052604011E-02 5.75781727928E-02 5.81568430497E-02 5.87413290395E-02 5.93316892111E-02 5.99279826010E-02 6.05302688392E-02 6.11386081547E-02 6.17530613819E-02 6.23736899668E-02 6.30005559726E-02 6.36337220865E-02 6.42732516257E-02 6.49192085435E-02 6.55716574364E-02 6.62306635496E-02 6.68962927844E-02 6.75686117042E-02 6.82476875414E-02 6.89335882043E-02 6.96263822835E-02 7.03261390589E-02 7.10329285068E-02 7.17468213068E-02 7.24678888487E-02 7.31962032399E-02 7.39318373124E-02 7.46748646302E-02 7.54253594967E-02 7.61833969620E-02 7.69490528305E-02 7.77224036685E-02 7.85035268115E-02 7.92925003727E-02 8.00894032499E-02 8.08943151343E-02 8.17073165175E-02 8.25284887005E-02 8.33579138012E-02 8.41956747626E-02 8.50418553618E-02 8.58965402173E-02 8.67598147984E-02 8.76317654334E-02 8.85124793178E-02 8.94020445240E-02 9.03005500092E-02 9.12080856245E-02 9.21247421245E-02 9.30506111754E-02 9.39857853650E-02 9.49303582115E-02 9.58844241729E-02 9.68480786566E-02 9.78214180289E-02 9.88045396245E-02 9.97975417564E-02 1.00800523726E-01 1.01813585831E-01 1.02836829380E-01 1.03870356698E-01 1.04914271138E-01 1.05968677092E-01 1.07033680003E-01 1.08109386370E-01 1.09195903767E-01 1.10293340845E-01 1.11401807348E-01 1.12521414126E-01 1.13652273138E-01 1.14794497473E-01 1.15948201353E-01 1.17113500149E-01 1.18290510394E-01 1.19479349788E-01 1.20680137216E-01 1.21892992759E-01 1.23118037702E-01 1.24355394552E-01 1.25605187045E-01 1.26867540162E-01 1.28142580138E-01 1.29430434479E-01 1.30731231971E-01 1.32045102696E-01 1.33372178041E-01 1.34712590714E-01 1.36066474759E-01 1.37433965565E-01 1.38815199882E-01 1.40210315835E-01 1.41619452936E-01 1.43042752100E-01 1.44480355659E-01 1.45932407374E-01 1.47399052451E-01 1.48880437556E-01 1.50376710829E-01 1.51888021898E-01 1.53414521897E-01 1.54956363475E-01 1.56513700818E-01 1.58086689663E-01 1.59675487308E-01 1.61280252634E-01 1.62901146121E-01 1.64538329857E-01 1.66191967564E-01 1.67862224606E-01 1.69549268011E-01 1.71253266483E-01 1.72974390425E-01 1.74712811950E-01 1.76468704902E-01 1.78242244871E-01 1.80033609214E-01 1.81842977067E-01 1.83670529370E-01 1.85516448878E-01 1.87380920186E-01 1.89264129743E-01 1.91166265870E-01 1.93087518782E-01 1.95028080608E-01 1.96988145404E-01 1.98967909179E-01 2.00967569911E-01 2.02987327567E-01 2.05027384125E-01 2.07087943592E-01 2.09169212026E-01 2.11271397556E-01 2.13394710402E-01 2.15539362896E-01 2.17705569506E-01 2.19893546855E-01 2.22103513742E-01 2.24335691165E-01 2.26590302344E-01 2.28867572742E-01 2.31167730088E-01 2.33491004400E-01 2.35837628007E-01 2.38207835573E-01 2.40601864122E-01 2.43019953057E-01 2.45462344190E-01 2.47929281762E-01 2.50421012468E-01 2.52937785485E-01 2.55479852491E-01 2.58047467695E-01 2.60640887861E-01 2.63260372333E-01 2.65906183062E-01 2.68578584630E-01 2.71277844281E-01 2.74004231942E-01 2.76758020255E-01 2.79539484601E-01 2.82348903128E-01 2.85186556780E-01 2.88052729326E-01 2.90947707385E-01 2.93871780457E-01 2.96825240951E-01 2.99808384218E-01 3.02821508572E-01 3.05864915330E-01 3.08938908835E-01 3.12043796487E-01 3.15179888779E-01 3.18347499323E-01 3.21546944882E-01 3.24778545404E-01 3.28042624050E-01 3.31339507233E-01 3.34669524642E-01 3.38033009283E-01 3.41430297506E-01 3.44861729043E-01 3.48327647041E-01 3.51828398094E-01 3.55364332280E-01 3.58935803195E-01 3.62543167990E-01 3.66186787403E-01 3.69867025801E-01 3.73584251209E-01 3.77338835353E-01 3.81131153696E-01 3.84961585472E-01 3.88830513727E-01 3.92738325357E-01 3.96685411147E-01 4.00672165809E-01 4.04698988022E-01 4.08766280470E-01 4.12874449887E-01 4.17023907093E-01 4.21215067038E-01 4.25448348840E-01 4.29724175831E-01 4.34042975598E-01 4.38405180025E-01 4.42811225335E-01 4.47261552136E-01 4.51756605465E-01 4.56296834832E-01 4.60882694262E-01 4.65514642345E-01 4.70193142281E-01 4.74918661923E-01 4.79691673826E-01 4.84512655297E-01 4.89382088437E-01 4.94300460194E-01 4.99268262409E-01 5.04285991866E-01 5.09354150342E-01 5.14473244658E-01 5.19643786727E-01 5.24866293608E-01 5.30141287556E-01 5.35469296074E-01 5.40850851968E-01 5.46286493398E-01 5.51776763932E-01 5.57322212603E-01 5.62923393960E-01 5.68580868124E-01 5.74295200850E-01 5.80066963574E-01 5.85896733478E-01 5.91785093544E-01 5.97732632612E-01 6.03739945441E-01 6.09807632768E-01 6.15936301367E-01 6.22126564109E-01 6.28379040025E-01 6.34694354370E-01 6.41073138679E-01 6.47516030835E-01 6.54023675135E-01 6.60596722347E-01 6.67235829782E-01 6.73941661356E-01 6.80714887657E-01 6.87556186015E-01 6.94466240564E-01 7.01445742316E-01 7.08495389227E-01 7.15615886267E-01 7.22807945492E-01 7.30072286114E-01 7.37409634573E-01 7.44820724610E-01 7.52306297340E-01 7.59867101327E-01 7.67503892657E-01 7.75217435016E-01 7.83008499764E-01 7.90877866015E-01 7.98826320712E-01 8.06854658706E-01 8.14963682839E-01 8.23154204019E-01 8.31427041305E-01 8.39783021989E-01 8.48222981674E-01 8.56747764365E-01 8.65358222546E-01 8.74055217270E-01 8.82839618244E-01 8.91712303916E-01 9.00674161561E-01 9.09726087374E-01 9.18868986552E-01 9.28103773396E-01 9.37431371390E-01 9.46852713302E-01 9.56368741275E-01 9.65980406919E-01 9.75688671409E-01 9.85494505578E-01 9.95398890020E-01 -2.31480981249E+01 -2.31480981038E+01 -2.31480980821E+01 -2.31480980601E+01 -2.31480980376E+01 -2.31480980146E+01 -2.31480979912E+01 -2.31480979673E+01 -2.31480979429E+01 -2.31480979180E+01 -2.31480978927E+01 -2.31480978668E+01 -2.31480978404E+01 -2.31480978134E+01 -2.31480977860E+01 -2.31480977579E+01 -2.31480977293E+01 -2.31480977001E+01 -2.31480976703E+01 -2.31480976400E+01 -2.31480976090E+01 -2.31480975774E+01 -2.31480975451E+01 -2.31480975122E+01 -2.31480974786E+01 -2.31480974444E+01 -2.31480974094E+01 -2.31480973738E+01 -2.31480973374E+01 -2.31480973003E+01 -2.31480972625E+01 -2.31480972239E+01 -2.31480971845E+01 -2.31480971443E+01 -2.31480971033E+01 -2.31480970614E+01 -2.31480970188E+01 -2.31480969752E+01 -2.31480969308E+01 -2.31480968855E+01 -2.31480968392E+01 -2.31480967921E+01 -2.31480967440E+01 -2.31480966949E+01 -2.31480966448E+01 -2.31480965937E+01 -2.31480965416E+01 -2.31480964884E+01 -2.31480964341E+01 -2.31480963788E+01 -2.31480963223E+01 -2.31480962647E+01 -2.31480962059E+01 -2.31480961460E+01 -2.31480960848E+01 -2.31480960224E+01 -2.31480959587E+01 -2.31480958938E+01 -2.31480958275E+01 -2.31480957599E+01 -2.31480956909E+01 -2.31480956206E+01 -2.31480955488E+01 -2.31480954756E+01 -2.31480954008E+01 -2.31480953246E+01 -2.31480952468E+01 -2.31480951675E+01 -2.31480950866E+01 -2.31480950040E+01 -2.31480949198E+01 -2.31480948338E+01 -2.31480947461E+01 -2.31480946567E+01 -2.31480945654E+01 -2.31480944723E+01 -2.31480943774E+01 -2.31480942805E+01 -2.31480941816E+01 -2.31480940808E+01 -2.31480939779E+01 -2.31480938729E+01 -2.31480937658E+01 -2.31480936565E+01 -2.31480935451E+01 -2.31480934314E+01 -2.31480933154E+01 -2.31480931970E+01 -2.31480930763E+01 -2.31480929531E+01 -2.31480928274E+01 -2.31480926992E+01 -2.31480925684E+01 -2.31480924350E+01 -2.31480922988E+01 -2.31480921599E+01 -2.31480920182E+01 -2.31480918737E+01 -2.31480917262E+01 -2.31480915758E+01 -2.31480914223E+01 -2.31480912657E+01 -2.31480911059E+01 -2.31480909429E+01 -2.31480907766E+01 -2.31480906070E+01 -2.31480904339E+01 -2.31480902574E+01 -2.31480900773E+01 -2.31480898935E+01 -2.31480897060E+01 -2.31480895147E+01 -2.31480893196E+01 -2.31480891205E+01 -2.31480889175E+01 -2.31480887103E+01 -2.31480884989E+01 -2.31480882832E+01 -2.31480880632E+01 -2.31480878388E+01 -2.31480876098E+01 -2.31480873762E+01 -2.31480871378E+01 -2.31480868947E+01 -2.31480866466E+01 -2.31480863936E+01 -2.31480861354E+01 -2.31480858720E+01 -2.31480856033E+01 -2.31480853291E+01 -2.31480850494E+01 -2.31480847641E+01 -2.31480844730E+01 -2.31480841760E+01 -2.31480838731E+01 -2.31480835640E+01 -2.31480832486E+01 -2.31480829269E+01 -2.31480825987E+01 -2.31480822639E+01 -2.31480819223E+01 -2.31480815738E+01 -2.31480812182E+01 -2.31480808555E+01 -2.31480804854E+01 -2.31480801079E+01 -2.31480797227E+01 -2.31480793298E+01 -2.31480789289E+01 -2.31480785200E+01 -2.31480781027E+01 -2.31480776771E+01 -2.31480772428E+01 -2.31480767998E+01 -2.31480763478E+01 -2.31480758867E+01 -2.31480754162E+01 -2.31480749363E+01 -2.31480744467E+01 -2.31480739472E+01 -2.31480734375E+01 -2.31480729176E+01 -2.31480723872E+01 -2.31480718461E+01 -2.31480712941E+01 -2.31480707309E+01 -2.31480701563E+01 -2.31480695701E+01 -2.31480689721E+01 -2.31480683620E+01 -2.31480677395E+01 -2.31480671045E+01 -2.31480664567E+01 -2.31480657958E+01 -2.31480651215E+01 -2.31480644336E+01 -2.31480637318E+01 -2.31480630158E+01 -2.31480622854E+01 -2.31480615402E+01 -2.31480607800E+01 -2.31480600044E+01 -2.31480592131E+01 -2.31480584059E+01 -2.31480575823E+01 -2.31480567422E+01 -2.31480558850E+01 -2.31480550105E+01 -2.31480541184E+01 -2.31480532082E+01 -2.31480522797E+01 -2.31480513324E+01 -2.31480503659E+01 -2.31480493800E+01 -2.31480483741E+01 -2.31480473479E+01 -2.31480463010E+01 -2.31480452329E+01 -2.31480441433E+01 -2.31480430316E+01 -2.31480418975E+01 -2.31480407405E+01 -2.31480395601E+01 -2.31480383558E+01 -2.31480371273E+01 -2.31480358739E+01 -2.31480345952E+01 -2.31480332907E+01 -2.31480319598E+01 -2.31480306020E+01 -2.31480292169E+01 -2.31480278037E+01 -2.31480263620E+01 -2.31480248911E+01 -2.31480233906E+01 -2.31480218597E+01 -2.31480202979E+01 -2.31480187046E+01 -2.31480170791E+01 -2.31480154208E+01 -2.31480137289E+01 -2.31480120029E+01 -2.31480102420E+01 -2.31480084456E+01 -2.31480066128E+01 -2.31480047431E+01 -2.31480028356E+01 -2.31480008895E+01 -2.31479989041E+01 -2.31479968787E+01 -2.31479948123E+01 -2.31479927042E+01 -2.31479905535E+01 -2.31479883594E+01 -2.31479861209E+01 -2.31479838372E+01 -2.31479815074E+01 -2.31479791306E+01 -2.31479767057E+01 -2.31479742319E+01 -2.31479717081E+01 -2.31479691333E+01 -2.31479665065E+01 -2.31479638267E+01 -2.31479610927E+01 -2.31479583035E+01 -2.31479554579E+01 -2.31479525549E+01 -2.31479495933E+01 -2.31479465718E+01 -2.31479434894E+01 -2.31479403446E+01 -2.31479371364E+01 -2.31479338633E+01 -2.31479305241E+01 -2.31479271175E+01 -2.31479236421E+01 -2.31479200965E+01 -2.31479164793E+01 -2.31479127890E+01 -2.31479090242E+01 -2.31479051834E+01 -2.31479012650E+01 -2.31478972674E+01 -2.31478931891E+01 -2.31478890285E+01 -2.31478847838E+01 -2.31478804534E+01 -2.31478760355E+01 -2.31478715284E+01 -2.31478669303E+01 -2.31478622393E+01 -2.31478574536E+01 -2.31478525712E+01 -2.31478475903E+01 -2.31478425087E+01 -2.31478373245E+01 -2.31478320356E+01 -2.31478266400E+01 -2.31478211353E+01 -2.31478155195E+01 -2.31478097903E+01 -2.31478039454E+01 -2.31477979824E+01 -2.31477918990E+01 -2.31477856928E+01 -2.31477793613E+01 -2.31477729019E+01 -2.31477663120E+01 -2.31477595891E+01 -2.31477527304E+01 -2.31477457333E+01 -2.31477385948E+01 -2.31477313122E+01 -2.31477238826E+01 -2.31477163029E+01 -2.31477085701E+01 -2.31477006813E+01 -2.31476926331E+01 -2.31476844225E+01 -2.31476760460E+01 -2.31476675004E+01 -2.31476587823E+01 -2.31476498882E+01 -2.31476408144E+01 -2.31476315575E+01 -2.31476221137E+01 -2.31476124792E+01 -2.31476026502E+01 -2.31475926227E+01 -2.31475823928E+01 -2.31475719564E+01 -2.31475613093E+01 -2.31475504472E+01 -2.31475393659E+01 -2.31475280608E+01 -2.31475165275E+01 -2.31475047614E+01 -2.31474927577E+01 -2.31474805118E+01 -2.31474680186E+01 -2.31474552733E+01 -2.31474422707E+01 -2.31474290056E+01 -2.31474154727E+01 -2.31474016667E+01 -2.31473875820E+01 -2.31473732131E+01 -2.31473585541E+01 -2.31473435992E+01 -2.31473283425E+01 -2.31473127779E+01 -2.31472968992E+01 -2.31472807000E+01 -2.31472641738E+01 -2.31472473142E+01 -2.31472301142E+01 -2.31472125672E+01 -2.31471946661E+01 -2.31471764038E+01 -2.31471577729E+01 -2.31471387661E+01 -2.31471193758E+01 -2.31470995942E+01 -2.31470794135E+01 -2.31470588255E+01 -2.31470378222E+01 -2.31470163952E+01 -2.31469945358E+01 -2.31469722354E+01 -2.31469494852E+01 -2.31469262759E+01 -2.31469025985E+01 -2.31468784434E+01 -2.31468538011E+01 -2.31468286617E+01 -2.31468030152E+01 -2.31467768515E+01 -2.31467501600E+01 -2.31467229301E+01 -2.31466951511E+01 -2.31466668119E+01 -2.31466379011E+01 -2.31466084073E+01 -2.31465783187E+01 -2.31465476234E+01 -2.31465163092E+01 -2.31464843636E+01 -2.31464517738E+01 -2.31464185270E+01 -2.31463846099E+01 -2.31463500090E+01 -2.31463147106E+01 -2.31462787006E+01 -2.31462419647E+01 -2.31462044883E+01 -2.31461662566E+01 -2.31461272543E+01 -2.31460874659E+01 -2.31460468757E+01 -2.31460054675E+01 -2.31459632248E+01 -2.31459201310E+01 -2.31458761688E+01 -2.31458313209E+01 -2.31457855694E+01 -2.31457388962E+01 -2.31456912828E+01 -2.31456427102E+01 -2.31455931593E+01 -2.31455426103E+01 -2.31454910433E+01 -2.31454384378E+01 -2.31453847728E+01 -2.31453300273E+01 -2.31452741794E+01 -2.31452172071E+01 -2.31451590878E+01 -2.31450997985E+01 -2.31450393157E+01 -2.31449776154E+01 -2.31449146733E+01 -2.31448504645E+01 -2.31447849635E+01 -2.31447181445E+01 -2.31446499810E+01 -2.31445804461E+01 -2.31445095123E+01 -2.31444371517E+01 -2.31443633355E+01 -2.31442880347E+01 -2.31442112195E+01 -2.31441328597E+01 -2.31440529242E+01 -2.31439713816E+01 -2.31438881998E+01 -2.31438033458E+01 -2.31437167863E+01 -2.31436284872E+01 -2.31435384137E+01 -2.31434465303E+01 -2.31433528009E+01 -2.31432571885E+01 -2.31431596555E+01 -2.31430601637E+01 -2.31429586738E+01 -2.31428551461E+01 -2.31427495397E+01 -2.31426418133E+01 -2.31425319246E+01 -2.31424198303E+01 -2.31423054867E+01 -2.31421888487E+01 -2.31420698707E+01 -2.31419485061E+01 -2.31418247074E+01 -2.31416984260E+01 -2.31415696126E+01 -2.31414382167E+01 -2.31413041870E+01 -2.31411674711E+01 -2.31410280156E+01 -2.31408857661E+01 -2.31407406669E+01 -2.31405926616E+01 -2.31404416924E+01 -2.31402877004E+01 -2.31401306258E+01 -2.31399704072E+01 -2.31398069825E+01 -2.31396402880E+01 -2.31394702589E+01 -2.31392968292E+01 -2.31391199316E+01 -2.31389394973E+01 -2.31387554565E+01 -2.31385677379E+01 -2.31383762686E+01 -2.31381809746E+01 -2.31379817803E+01 -2.31377786088E+01 -2.31375713815E+01 -2.31373600184E+01 -2.31371444380E+01 -2.31369245571E+01 -2.31367002911E+01 -2.31364715536E+01 -2.31362382565E+01 -2.31360003103E+01 -2.31357576235E+01 -2.31355101029E+01 -2.31352576536E+01 -2.31350001789E+01 -2.31347375801E+01 -2.31344697568E+01 -2.31341966067E+01 -2.31339180252E+01 -2.31336339063E+01 -2.31333441414E+01 -2.31330486203E+01 -2.31327472304E+01 -2.31324398571E+01 -2.31321263837E+01 -2.31318066913E+01 -2.31314806585E+01 -2.31311481620E+01 -2.31308090758E+01 -2.31304632718E+01 -2.31301106195E+01 -2.31297509858E+01 -2.31293842353E+01 -2.31290102298E+01 -2.31286288288E+01 -2.31282398890E+01 -2.31278432646E+01 -2.31274388069E+01 -2.31270263647E+01 -2.31266057837E+01 -2.31261769069E+01 -2.31257395746E+01 -2.31252936237E+01 -2.31248388885E+01 -2.31243752002E+01 -2.31239023866E+01 -2.31234202727E+01 -2.31229286802E+01 -2.31224274275E+01 -2.31219163297E+01 -2.31213951985E+01 -2.31208638422E+01 -2.31203220658E+01 -2.31197696705E+01 -2.31192064541E+01 -2.31186322107E+01 -2.31180467307E+01 -2.31174498006E+01 -2.31168412033E+01 -2.31162207176E+01 -2.31155881186E+01 -2.31149431772E+01 -2.31142856602E+01 -2.31136153303E+01 -2.31129319461E+01 -2.31122352618E+01 -2.31115250272E+01 -2.31108009879E+01 -2.31100628848E+01 -2.31093104545E+01 -2.31085434286E+01 -2.31077615344E+01 -2.31069644942E+01 -2.31061520255E+01 -2.31053238409E+01 -2.31044796480E+01 -2.31036191492E+01 -2.31027420421E+01 -2.31018480187E+01 -2.31009367658E+01 -2.31000079649E+01 -2.30990612918E+01 -2.30980964171E+01 -2.30971130053E+01 -2.30961107156E+01 -2.30950892009E+01 -2.30940481087E+01 -2.30929870800E+01 -2.30919057501E+01 -2.30908037477E+01 -2.30896806956E+01 -2.30885362100E+01 -2.30873699004E+01 -2.30861813702E+01 -2.30849702155E+01 -2.30837360261E+01 -2.30824783846E+01 -2.30811968665E+01 -2.30798910404E+01 -2.30785604674E+01 -2.30772047014E+01 -2.30758232886E+01 -2.30744157676E+01 -2.30729816694E+01 -2.30715205169E+01 -2.30700318251E+01 -2.30685151007E+01 -2.30669698423E+01 -2.30653955397E+01 -2.30637916745E+01 -2.30621577192E+01 -2.30604931374E+01 -2.30587973839E+01 -2.30570699040E+01 -2.30553101335E+01 -2.30535174987E+01 -2.30516914162E+01 -2.30498312924E+01 -2.30479365236E+01 -2.30460064957E+01 -2.30440405840E+01 -2.30420381530E+01 -2.30399985560E+01 -2.30379211352E+01 -2.30358052210E+01 -2.30336501323E+01 -2.30314551757E+01 -2.30292196457E+01 -2.30269428239E+01 -2.30246239791E+01 -2.30222623670E+01 -2.30198572296E+01 -2.30174077951E+01 -2.30149132775E+01 -2.30123728761E+01 -2.30097857753E+01 -2.30071511443E+01 -2.30044681362E+01 -2.30017358883E+01 -2.29989535210E+01 -2.29961201379E+01 -2.29932348246E+01 -2.29902966492E+01 -2.29873046607E+01 -2.29842578893E+01 -2.29811553454E+01 -2.29779960191E+01 -2.29747788796E+01 -2.29715028747E+01 -2.29681669297E+01 -2.29647699474E+01 -2.29613108065E+01 -2.29577883617E+01 -2.29542014422E+01 -2.29505488514E+01 -2.29468293658E+01 -2.29430417339E+01 -2.29391846758E+01 -2.29352568818E+01 -2.29312570115E+01 -2.29271836926E+01 -2.29230355201E+01 -2.29188110550E+01 -2.29145088230E+01 -2.29101273135E+01 -2.29056649779E+01 -2.29011202288E+01 -2.28964914380E+01 -2.28917769357E+01 -2.28869750081E+01 -2.28820838969E+01 -2.28771017966E+01 -2.28720268536E+01 -2.28668571640E+01 -2.28615907719E+01 -2.28562256673E+01 -2.28507597843E+01 -2.28451909991E+01 -2.28395171276E+01 -2.28337359233E+01 -2.28278450750E+01 -2.28218422044E+01 -2.28157248637E+01 -2.28094905327E+01 -2.28031366165E+01 -2.27966604427E+01 -2.27900592582E+01 -2.27833302265E+01 -2.27764704247E+01 -2.27694768400E+01 -2.27623463669E+01 -2.27550758033E+01 -2.27476618474E+01 -2.27401010935E+01 -2.27323900291E+01 -2.27245250303E+01 -2.27165023581E+01 -2.27083181544E+01 -2.26999684373E+01 -2.26914490972E+01 -2.26827558923E+01 -2.26738844433E+01 -2.26648302295E+01 -2.26555885831E+01 -2.26461546848E+01 -2.26365235579E+01 -2.26266900636E+01 -2.26166488952E+01 -2.26063945721E+01 -2.25959214347E+01 -2.25852236382E+01 -2.25742951460E+01 -2.25631297241E+01 -2.25517209348E+01 -2.25400621292E+01 -2.25281464418E+01 -2.25159667825E+01 -2.25035158306E+01 -2.24907860269E+01 -2.24777695670E+01 -2.24644583934E+01 -2.24508441887E+01 -2.24369183669E+01 -2.24226720668E+01 -2.24080961430E+01 -2.23931811587E+01 -2.23779173771E+01 -2.23622947535E+01 -2.23463029268E+01 -2.23299312109E+01 -2.23131685870E+01 -2.22960036941E+01 -2.22784248212E+01 -2.22604198984E+01 -2.22419764882E+01 -2.22230817773E+01 -2.22037225674E+01 -2.21838852674E+01 -2.21635558840E+01 -2.21427200142E+01 -2.21213628365E+01 -2.20994691025E+01 -2.20770231296E+01 -2.20540087924E+01 -2.20304095156E+01 -2.20062082662E+01 -2.19813875470E+01 -2.19559293891E+01 -2.19298153460E+01 -2.19030264876E+01 -2.18755433944E+01 -2.18473461524E+01 -2.18184143492E+01 -2.17887270690E+01 -2.17582628906E+01 -2.17269998839E+01 -2.16949156086E+01 -2.16619871130E+01 -2.16281909342E+01 -2.15935030991E+01 -2.15578991260E+01 -2.15213540283E+01 -2.14838423183E+01 -2.14453380130E+01 -2.14058146415E+01 -2.13652452527E+01 -2.13236024260E+01 -2.12808582827E+01 -2.12369844993E+01 -2.11919523231E+01 -2.11457325893E+01 -2.10982957401E+01 -2.10496118467E+01 -2.09996506327E+01 -2.09483815004E+01 -2.08957735597E+01 -2.08417956590E+01 -2.07864164202E+01 -2.07296042748E+01 -2.06713275046E+01 -2.06115542846E+01 -2.05502527295E+01 -2.04873909436E+01 -2.04229370739E+01 -2.03568593673E+01 -2.02891262313E+01 -2.02197062980E+01 -2.01485684935E+01 -2.00756821095E+01 -2.00010168805E+01 -1.99245430650E+01 -1.98462315301E+01 -1.97660538416E+01 -1.96839823585E+01 -1.95999903308E+01 -1.95140520036E+01 -1.94261427245E+01 -1.93362390562E+01 -1.92443188934E+01 -1.91503615844E+01 -1.90543480572E+01 -1.89562609500E+01 -1.88560847462E+01 -1.87538059132E+01 -1.86494130460E+01 -1.85428970135E+01 -1.84342511100E+01 -1.83234712089E+01 -1.82105559200E+01 -1.80955067494E+01 -1.79783282626E+01 -1.78590282480E+01 -1.77376178841E+01 -1.76141119058E+01 -1.74885287720E+01 -1.73608908334E+01 -1.72312244990E+01 -1.70995604005E+01 -1.69659335555E+01 -1.68303835264E+01 -1.66929545753E+01 -1.65536958135E+01 -1.64126613452E+01 -1.62699104021E+01 -1.61255074707E+01 -1.59795224075E+01 -1.58320305437E+01 -1.56831127753E+01 -1.55328556383E+01 -1.53813513664E+01 -1.52286979296E+01 -1.50749990512E+01 -1.49203642012E+01 -1.47649085630E+01 -1.46087529716E+01 -1.44520238195E+01 -1.42948529283E+01 -1.41373773820E+01 -1.39797393185E+01 -1.38220856767E+01 -1.36645678938E+01 -1.35073415506E+01 -1.33505659588E+01 -1.31944036870E+01 -1.30390200213E+01 -1.28845823540E+01 -1.27312594977E+01 -1.25792209195E+01 -1.24286358898E+01 -1.22796725429E+01 -1.21324968437E+01 -1.19872714584E+01 -1.18441545256E+01 -1.17032983260E+01 -1.15648478507E+01 -1.14289392686E+01 -1.12956982958E+01 -1.11652384747E+01 -1.10376593689E+01 -1.09130446896E+01 -1.07914603689E+01 -1.06729526048E+01 -1.05575459072E+01 -1.04452411826E+01 -1.03360139051E+01 -1.02297081790E+01 -1.01264025698E+01 -1.00259336983E+01 -9.92816108877E+00 -9.83291348251E+00 -9.73998925087E+00 -9.64915763770E+00 -9.56016102568E+00 -9.47271845236E+00 -9.38653063724E+00 -9.30128682133E+00 -9.21667376610E+00 -9.13238730983E+00 -9.04814693783E+00 -8.96371388845E+00 -8.87891339248E+00 -8.79366172868E+00 -8.70799887608E+00 -8.62212765517E+00 -8.53646037697E+00 -8.45152104419E+00 -8.36742689891E+00 -8.28416952590E+00 -8.20174059433E+00 -8.12013185680E+00 -8.03933514850E+00 -7.95934238628E+00 -7.88014556780E+00 -7.80173677070E+00 -7.72410815171E+00 -7.64725194590E+00 -7.57116046580E+00 -7.49582610066E+00 -7.42124131559E+00 -7.34739865082E+00 -7.27429072096E+00 -7.20191021418E+00 -7.13024989153E+00 -7.05930258615E+00 -6.98906120258E+00 -6.91951871601E+00 -6.85066817158E+00 -6.78250329022E+00 -6.71501664837E+00 -6.64820149763E+00 -6.58205115675E+00 -6.51655901099E+00 -6.45171851143E+00 -6.38752317433E+00 -6.32396658046E+00 -6.26104237446E+00 -6.19874426423E+00 -6.13706602026E+00 -6.07600147504E+00 -6.01554452242E+00 -5.95568911698E+00 -5.89642927350E+00 -5.83775906626E+00 -5.77967262852E+00 -5.72216415192E+00 -5.66522788588E+00 -5.60885813702E+00 -5.55304926863E+00 -5.49779570007E+00 -5.44309190621E+00 -5.38893241692E+00 -5.33531181647E+00 -5.28222474302E+00 -5.22966588807E+00 -5.17762999596E+00 -5.12611186329E+00 -5.07510633845E+00 -5.02460832107E+00 -4.97461276154E+00 -4.92511466049E+00 -4.87610906828E+00 -4.82759108453E+00 -4.77955585760E+00 -4.73199858413E+00 -4.68491450856E+00 -4.63829892264E+00 -4.59214716495E+00 -4.54645462047E+00 -4.50121672008E+00 -4.45642894015E+00 -4.41208680203E+00 -4.36818587163E+00 -4.32472175901E+00 -4.28169011787E+00 -4.23908664519E+00 -4.19690708072E+00 -4.15514720665E+00 -4.11380284710E+00 -4.07286986775E+00 -4.03234417541E+00 -3.99222171763E+00 -3.95249848226E+00 -3.91317049710E+00 -3.87423382944E+00 -3.83568458572E+00 -3.79751891111E+00 -3.75973298914E+00 -3.72232304132E+00 -3.68528532673E+00 -3.64861614169E+00 -3.61231181937E+00 -3.57636872943E+00 -3.54078327762E+00 -3.50555190549E+00 -3.47067108997E+00 -3.43613734306E+00 -3.40194721144E+00 -3.36809727617E+00 -3.33458415233E+00 -3.30140448865E+00 -3.26855496724E+00 -3.23603230319E+00 -3.20383324429E+00 -3.17195457069E+00 -3.14039309457E+00 -3.10914565982E+00 -3.07820914173E+00 -3.04758044671E+00 -3.01725651190E+00 -2.98723430496E+00 -2.95751082369E+00 -2.92808309577E+00 -2.89894817846E+00 -2.87010315828E+00 -2.84154515074E+00 -2.81327130008E+00 -2.78527877890E+00 -2.75756478799E+00 -2.73012655593E+00 -2.70296133893E+00 -2.67606642046E+00 -2.64943911102E+00 -2.62307674790E+00 -2.59697669485E+00 -2.57113634186E+00 -2.54555310490E+00 -2.52022442562E+00 -2.49514777115E+00 -2.47032063382E+00 -2.44574053090E+00 -2.42140500436E+00 -2.39731162063E+00 -2.37345797036E+00 -2.34984166816E+00 -2.32646035239E+00 -2.30331168489E+00 -2.28039335077E+00 -2.25770305818E+00 -2.23523853806E+00 -2.21299754393E+00 -2.19097785167E+00 -2.16917725929E+00 -2.14759358670E+00 -2.12622467550E+00 -2.10506838878E+00 -2.08412261088E+00 -2.06338524719E+00 -2.04285422394E+00 -2.02252748802E+00 -2.00240300670E+00 -1.98247876753E+00 -1.96275277804E+00 -1.94322306561E+00 -1.92388767724E+00 -1.90474467935E+00 -1.88579215763E+00 -1.86702821679E+00 -1.84845098041E+00 -1.83005859074E+00 -1.81184920851E+00 -1.79382101276E+00 -1.77597220064E+00 -1.75830098724E+00 -1.74080560542E+00 -1.72348430562E+00 -1.70633535568E+00 -1.68935704067E+00 -1.67254766276E+00 -1.65590554096E+00 -1.63942901106E+00 -1.62311642537E+00 -1.60696615262E+00 -1.59097657775E+00 -1.57514610179E+00 -1.55947314167E+00 -1.54395613007E+00 -1.52859351528E+00 -1.51338376102E+00 -1.49832534628E+00 -1.48341676522E+00 -1.46865652696E+00 -1.45404315545E+00 -1.43957518935E+00 -1.42525118184E+00 -1.41106970051E+00 -1.39702932719E+00 -1.38312865783E+00 -1.36936630236E+00 -1.35574088451E+00 -1.34225104175E+00 -1.32889542507E+00 -1.31567269889E+00 -1.30258154079E+00 -1.28962064194E+00 -1.27678870609E+00 -1.26408445003E+00 -1.25150660333E+00 -1.23905390819E+00 -1.22672511933E+00 -1.21451900385E+00 -1.20243434115E+00 -1.19046992275E+00 -1.17862455219E+00 -1.16689704493E+00 -1.15528622821E+00 -1.14379094094E+00 -1.13241003358E+00 -1.12114236803E+00 -1.10998681753E+00 -1.09894226649E+00 -1.08800761051E+00 -1.07718175570E+00 -1.06646362199E+00 -1.05585213054E+00 -1.04534627565E+00 -1.03494490634E+00 -1.02464703084E+00 -1.01445162255E+00 -1.00435766026E+00 -9.94364134700E-01 -9.84470046246E-01 -9.74674405618E-01 -9.64976233242E-01 -9.55374559293E-01 -9.45868423597E-01 -9.36456875531E-01 -9.27138973933E-01 -9.17913787005E-01 -9.08780392221E-01 -8.99737876233E-01 -8.90785334783E-01 -8.81921872608E-01 -8.73146603356E-01 -8.64458649492E-01 -8.55857142213E-01 -8.47341221361E-01 -8.38910035338E-01 -8.30562741017E-01 -8.22298503663E-01 -8.14116496844E-01 -8.06015902353E-01 -7.97995910124E-01 -7.90055718151E-01 -7.82194532408E-01 -7.74411566771E-01 -7.66706042935E-01 -7.59077190342E-01 -7.51524246101E-01 -7.44046454911E-01 -7.36643068986E-01 -7.29313347982E-01 -7.22056558921E-01 -7.14871976117E-01 -7.07758881107E-01 -7.00716562574E-01 -6.93744316282E-01 -6.86841444999E-01 -6.80007258433E-01 -6.73241073160E-01 -6.66542212555E-01 -6.59910006727E-01 -6.53343792449E-01 -6.46842913095E-01 -6.40406718572E-01 -6.34034565254E-01 -6.27725815921E-01 -6.21479839693E-01 -6.15296011966E-01 -6.09173714354E-01 -6.03112334620E-01 -5.97111266623E-01 -5.91169910250E-01 -5.85287671360E-01 -5.79463961726E-01 -5.73698198970E-01 -5.67989806512E-01 -5.62338213509E-01 -5.56742854795E-01 -5.51203170831E-01 -5.45718607643E-01 -5.40288616771E-01 -5.34912655211E-01 -5.29590185362E-01 -5.24320674973E-01 -5.19103597088E-01 -5.13938429995E-01 -5.08824657174E-01 -5.03761767243E-01 -4.98749253908E-01 -4.93786615914E-01 -4.88873356993E-01 -4.84008985816E-01 -4.79193015940E-01 -4.74424965765E-01 -4.69704358482E-01 -4.65030722026E-01 -4.60403589031E-01 -4.55822496777E-01 -4.51286987153E-01 -4.46796606604E-01 -4.42350906088E-01 -4.37949441032E-01 -4.33591771284E-01 -4.29277461075E-01 -4.25006078969E-01 -4.20777197826E-01 -4.16590394753E-01 -4.12445251067E-01 -4.08341352249E-01 -4.04278287907E-01 -4.00255651731E-01 -3.96273041453E-01 -3.92330058810E-01 -3.88426309500E-01 -3.84561403144E-01 -3.80734953249E-01 -3.76946577167E-01 -3.73195896056E-01 -3.69482534846E-01 -3.65806122198E-01 -3.62166290466E-01 -3.58562675666E-01 -3.54994917432E-01 -3.51462658985E-01 -3.47965547097E-01 -3.44503232054E-01 -3.41075367621E-01 -3.37681611009E-01 -3.34321622840E-01 -3.30995067111E-01 -3.27701611165E-01 -3.24440925654E-01 -3.21212684505E-01 -3.18016564892E-01 -3.14852247201E-01 -3.11719414997E-01 -3.08617754994E-01 -3.05546957024E-01 -3.02506714004E-01 -2.99496721908E-01 -2.96516679733E-01 -2.93566289474E-01 -2.90645256088E-01 -2.87753287470E-01 -2.84890094420E-01 -2.82055390617E-01 -2.79248892589E-01 -2.76470319682E-01 -2.73719394038E-01 -2.70995840561E-01 -2.68299386894E-01 -2.65629763390E-01 -2.62986703083E-01 -2.60369941665E-01 -2.57779217459E-01 -2.55214271389E-01 -2.52674846959E-01 -2.50160690225E-01 -2.47671549768E-01 -2.45207176672E-01 -2.42767324498E-01 -2.40351749259E-01 -2.37960209395E-01 -2.35592465751E-01 -2.33248281549E-01 -2.30927422370E-01 -2.28629656125E-01 -2.26354753037E-01 -2.24102485613E-01 -2.21872628624E-01 -2.19664959082E-01 -2.17479256220E-01 -2.15315301464E-01 -2.13172878418E-01 -2.11051772838E-01 -2.08951772611E-01 -2.06872667735E-01 -2.04814250298E-01 -2.02776314457E-01 -2.00758656417E-01 -1.98761074409E-01 -1.96783368674E-01 -1.94825341441E-01 -1.92886796903E-01 -1.90967541207E-01 -1.89067382423E-01 -1.87186130535E-01 -1.85323597417E-01 -1.83479596812E-01 -1.81653944320E-01 -1.79846457374E-01 -1.78056955224E-01 -1.76285258917E-01 -1.74531191283E-01 -1.72794576914E-01 -1.71075242147E-01 -1.69373015046E-01 -1.67687725388E-01 -1.66019204642E-01 -1.64367285955E-01 -1.62731804133E-01 -1.61112595628E-01 -1.59509498516E-01 -1.57922352488E-01 -1.56350998826E-01 -1.54795280394E-01 -1.53255041619E-01 -1.51730128476E-01 -1.50220388473E-01 -1.48725670633E-01 -1.47245825484E-01 -1.45780705041E-01 -1.44330162790E-01 -1.42894053675E-01 -1.41472234085E-01 -1.40064561836E-01 -1.38670896160E-01 -1.37291097689E-01 -1.35925028442E-01 -1.34572551811E-01 -1.33233532548E-01 -1.31907836749E-01 -1.30595331843E-01 -1.29295886580E-01 -1.28009371013E-01 -1.26735656490E-01 -1.25474615638E-01 -1.24226122352E-01 -1.22990051782E-01 -1.21766280319E-01 -1.20554685586E-01 1 0 Beta L 865 1.93353130466E-03 1.95296376276E-03 1.97259152474E-03 1.99241655356E-03 2.01208139521E-03 2.03070245403E-03 2.05437624996E-03 2.07346858618E-03 2.09330362067E-03 2.11628207985E-03 2.13592561143E-03 2.15961534244E-03 2.17886501896E-03 2.20304009611E-03 2.22250961396E-03 2.24660132351E-03 2.27062450193E-03 2.29050800059E-03 2.31491748256E-03 2.33926062597E-03 2.36052825962E-03 2.38547197223E-03 2.40938531499E-03 2.43362136317E-03 2.45799163831E-03 2.48284102805E-03 2.50847299108E-03 2.53230030988E-03 2.55932239884E-03 2.58481061706E-03 2.60913853758E-03 2.63685492226E-03 2.66336033063E-03 2.69000313404E-03 2.71594699254E-03 2.74358248711E-03 2.77121647499E-03 2.80019265877E-03 2.82763385970E-03 2.85599594252E-03 2.88491907973E-03 2.91434732966E-03 2.94245624981E-03 2.97388782486E-03 3.00211636622E-03 3.03288397742E-03 3.06280909862E-03 3.09427883085E-03 3.12553880807E-03 3.15549021272E-03 3.18866662917E-03 3.21989372461E-03 3.25221433107E-03 3.28511371407E-03 3.31886563593E-03 3.35179136159E-03 3.38457653870E-03 3.41842705284E-03 3.45342882832E-03 3.48774855681E-03 3.52283301293E-03 3.55853056677E-03 3.59407041349E-03 3.63098827745E-03 3.66699226761E-03 3.70355173156E-03 3.74112204750E-03 3.77862487996E-03 3.81583301092E-03 3.85531283537E-03 3.89382389795E-03 3.93207610836E-03 3.97215766679E-03 4.01130581615E-03 4.05198037239E-03 4.09354837836E-03 4.13423059716E-03 4.17506434993E-03 4.21786607930E-03 4.26058334257E-03 4.30322824491E-03 4.34656346646E-03 4.39059520393E-03 4.43349725265E-03 4.47860223951E-03 4.52306684116E-03 4.56992630424E-03 4.61501802002E-03 4.66055826560E-03 4.70765662108E-03 4.75568923496E-03 4.80361795263E-03 4.85183379043E-03 4.90080150319E-03 4.94956437489E-03 4.99985018359E-03 5.05017100232E-03 5.10001654450E-03 5.15217582972E-03 5.20406874586E-03 5.25606712049E-03 5.30875513096E-03 5.36216893514E-03 5.41590734674E-03 5.47000697707E-03 5.52512779522E-03 5.58080538213E-03 5.63706414885E-03 5.69317508703E-03 5.75092558554E-03 5.80834383836E-03 5.86720798828E-03 5.92629230560E-03 5.98540301166E-03 6.04564575842E-03 6.10599542384E-03 6.16782093179E-03 6.22967579607E-03 6.29225143664E-03 6.35513594761E-03 6.41963259372E-03 6.48374561940E-03 6.54921223436E-03 6.61463734131E-03 6.68189511407E-03 6.74849124565E-03 6.81662781643E-03 6.88513758913E-03 6.95369619810E-03 7.02406308347E-03 7.09482204330E-03 7.16539436252E-03 7.23823604474E-03 7.31053191145E-03 7.38429891984E-03 7.45824389953E-03 7.53361333405E-03 7.60924507584E-03 7.68489038248E-03 7.76264383198E-03 7.84106863644E-03 7.91972111918E-03 7.99893259527E-03 8.08016569319E-03 8.16062290124E-03 8.24262499821E-03 8.32569848116E-03 8.40917102023E-03 8.49384050469E-03 8.57925553344E-03 8.66551916937E-03 8.75236671541E-03 8.84058014927E-03 8.92915965500E-03 9.01898739504E-03 9.10959452613E-03 9.20138490096E-03 9.29361625151E-03 9.38736108632E-03 9.48126917704E-03 9.57723158599E-03 9.67288742812E-03 9.77027323096E-03 9.86842795744E-03 9.96766478743E-03 1.00677355615E-02 1.01693440692E-02 1.02712719785E-02 1.03745043027E-02 1.04786459400E-02 1.05841974588E-02 1.06903965614E-02 1.07977152631E-02 1.09064670461E-02 1.10157867496E-02 1.11266219730E-02 1.12388335273E-02 1.13511803795E-02 1.14658796662E-02 1.15804934855E-02 1.16973812388E-02 1.18147245983E-02 1.19332811146E-02 1.20533537489E-02 1.21744086034E-02 1.22968299790E-02 1.24203416325E-02 1.25454659528E-02 1.26713330411E-02 1.27987824865E-02 1.29273326942E-02 1.30574914966E-02 1.31883286165E-02 1.33214894746E-02 1.34547516470E-02 1.35900884162E-02 1.37267393165E-02 1.38647984987E-02 1.40041123344E-02 1.41450897811E-02 1.42870563695E-02 1.44306745985E-02 1.45755021191E-02 1.47222812512E-02 1.48701127426E-02 1.50196928137E-02 1.51701580073E-02 1.53230756101E-02 1.54768569565E-02 1.56326046779E-02 1.57896350978E-02 1.59483648528E-02 1.61085318549E-02 1.62704423143E-02 1.64340021814E-02 1.65990028495E-02 1.67660997850E-02 1.69344430280E-02 1.71048051364E-02 1.72765418068E-02 1.74501704534E-02 1.76256114232E-02 1.78027439470E-02 1.79818272256E-02 1.81623376354E-02 1.83448302549E-02 1.85295033136E-02 1.87155930590E-02 1.89036640440E-02 1.90938026893E-02 1.92855233835E-02 1.94794132525E-02 1.96750311530E-02 1.98730097830E-02 2.00726707318E-02 2.02743717981E-02 2.04782333060E-02 2.06839346190E-02 2.08920200575E-02 2.11018136609E-02 2.13139037925E-02 2.15281558201E-02 2.17444338219E-02 2.19629839422E-02 2.21837999349E-02 2.24067768407E-02 2.26318860640E-02 2.28595647466E-02 2.30890150869E-02 2.33212021397E-02 2.35556010287E-02 2.37923545433E-02 2.40313289780E-02 2.42730620555E-02 2.45170587040E-02 2.47633344459E-02 2.50124017011E-02 2.52635294454E-02 2.55177195666E-02 2.57739429740E-02 2.60332524831E-02 2.62946134472E-02 2.65590218078E-02 2.68260436104E-02 2.70954852227E-02 2.73679982168E-02 2.76429736601E-02 2.79208059787E-02 2.82015196903E-02 2.84848572326E-02 2.87712397993E-02 2.90604195575E-02 2.93524246474E-02 2.96474888338E-02 2.99454957931E-02 3.02464351952E-02 3.05503664505E-02 3.08575188966E-02 3.11676338769E-02 3.14808893662E-02 3.17973612318E-02 3.21168550779E-02 3.24397261296E-02 3.27658143277E-02 3.30949421668E-02 3.34278094560E-02 3.37636642310E-02 3.41030680073E-02 3.44457218467E-02 3.47920318627E-02 3.51417049655E-02 3.54949687079E-02 3.58517344222E-02 3.62121421710E-02 3.65760608481E-02 3.69436724538E-02 3.73150193120E-02 3.76900052961E-02 3.80688574502E-02 3.84515663060E-02 3.88379709553E-02 3.92283281465E-02 3.96226743812E-02 4.00208473914E-02 4.04232792759E-02 4.08294972167E-02 4.12399327237E-02 4.16544921721E-02 4.20730988125E-02 4.24960226013E-02 4.29231725531E-02 4.33546037791E-02 4.37904263102E-02 4.42304304544E-02 4.46751707124E-02 4.51241862527E-02 4.55777921578E-02 4.60359099804E-02 4.64987124533E-02 4.69660348489E-02 4.74382033586E-02 4.79148537781E-02 4.83966724888E-02 4.88830695932E-02 4.93744881702E-02 4.98707403677E-02 5.03720914394E-02 5.08783875464E-02 5.13899196084E-02 5.19064227963E-02 5.24282469641E-02 5.29551759342E-02 5.34875945840E-02 5.40251842816E-02 5.45683348973E-02 5.51168463419E-02 5.56709374195E-02 5.62305444087E-02 5.67957824277E-02 5.73667497120E-02 5.79434386687E-02 5.85259497847E-02 5.91142351323E-02 5.97085358089E-02 6.03088054965E-02 6.09149490603E-02 6.15274080902E-02 6.21458821253E-02 6.27707368846E-02 6.34016998323E-02 6.40390696423E-02 6.46829272570E-02 6.53331555805E-02 6.59900254221E-02 6.66534161876E-02 6.73235023381E-02 6.80003504783E-02 6.86840223035E-02 6.93745566565E-02 7.00719722783E-02 7.07765013364E-02 7.14881560422E-02 7.22068112575E-02 7.29328317220E-02 7.36660963902E-02 7.44067556611E-02 7.51548749968E-02 7.59104958872E-02 7.66737455644E-02 7.74446592661E-02 7.82233612101E-02 7.90098354747E-02 7.98042537007E-02 8.06067282409E-02 8.14172120875E-02 8.22358743639E-02 8.30627692438E-02 8.38980165475E-02 8.47415728611E-02 8.55937220836E-02 8.64544161760E-02 8.73238343555E-02 8.82019461289E-02 8.90888340588E-02 8.99847822563E-02 9.08896597591E-02 9.18037442649E-02 9.27269192767E-02 9.36594606073E-02 9.46013329507E-02 9.55527059730E-02 9.65136998015E-02 9.74843636331E-02 9.84647963361E-02 9.94550836472E-02 1.00455345222E-01 1.01465774174E-01 1.02486258170E-01 1.03517063479E-01 1.04558240059E-01 1.05609927599E-01 1.06672229594E-01 1.07745187991E-01 1.08829007725E-01 1.09923733878E-01 1.11029453385E-01 1.12146312847E-01 1.13274509989E-01 1.14413989635E-01 1.15565023651E-01 1.16727604587E-01 1.17901931142E-01 1.19088109329E-01 1.20286236204E-01 1.21496424877E-01 1.22718816210E-01 1.23953593984E-01 1.25200727266E-01 1.26460487142E-01 1.27733001524E-01 1.29018254394E-01 1.30316542687E-01 1.31627904421E-01 1.32952501525E-01 1.34290464005E-01 1.35641903948E-01 1.37007019751E-01 1.38385904099E-01 1.39778680056E-01 1.41185546063E-01 1.42606579391E-01 1.44041982232E-01 1.45491916697E-01 1.46956443931E-01 1.48435733822E-01 1.49930005078E-01 1.51439360349E-01 1.52963976107E-01 1.54503983488E-01 1.56059543329E-01 1.57630836746E-01 1.59217992532E-01 1.60821210530E-01 1.62440591594E-01 1.64076422174E-01 1.65728752624E-01 1.67397780443E-01 1.69083675072E-01 1.70786660640E-01 1.72506859502E-01 1.74244437487E-01 1.75999628444E-01 1.77772561617E-01 1.79563461220E-01 1.81372497424E-01 1.83199787340E-01 1.85045656735E-01 1.86910177676E-01 1.88793606173E-01 1.90696098499E-01 1.92617897311E-01 1.94559126582E-01 1.96520053614E-01 1.98500885124E-01 2.00501783233E-01 2.02522949520E-01 2.04564665543E-01 2.06627043152E-01 2.08710380044E-01 2.10814853168E-01 2.12940700813E-01 2.15088132867E-01 2.17257372653E-01 2.19448633858E-01 2.21662178407E-01 2.23898215521E-01 2.26156960129E-01 2.28438714999E-01 2.30743615330E-01 2.33072006700E-01 2.35424068472E-01 2.37800093532E-01 2.40200277048E-01 2.42624919949E-01 2.45074250466E-01 2.47548544437E-01 2.50048041531E-01 2.52573054477E-01 2.55123788810E-01 2.57700545051E-01 2.60303599601E-01 2.62933214641E-01 2.65589688894E-01 2.68273296146E-01 2.70984325720E-01 2.73723059472E-01 2.76489789212E-01 2.79284830432E-01 2.82108458007E-01 2.84961008474E-01 2.87842752353E-01 2.90754014213E-01 2.93695140328E-01 2.96666388105E-01 2.99668109435E-01 3.02700668287E-01 3.05764326374E-01 3.08859449521E-01 3.11986398385E-01 3.15145468076E-01 3.18337039792E-01 3.21561454264E-01 3.24819068313E-01 3.28110227615E-01 3.31435328096E-01 3.34794675956E-01 3.38188712692E-01 3.41617774999E-01 3.45082255213E-01 3.48582552568E-01 3.52119021576E-01 3.55692099228E-01 3.59302174395E-01 3.62949647693E-01 3.66634946731E-01 3.70358469208E-01 3.74120645751E-01 3.77921908922E-01 3.81762693563E-01 3.85643440937E-01 3.89564579600E-01 3.93526583977E-01 3.97529901569E-01 4.01574996552E-01 4.05662344168E-01 4.09792422867E-01 4.13965714681E-01 4.18182694566E-01 4.22443875110E-01 4.26749773003E-01 4.31100861027E-01 4.35497707428E-01 4.39940787479E-01 4.44430676801E-01 4.48967889033E-01 4.53552987178E-01 4.58186532171E-01 4.62869073904E-01 4.67601195213E-01 4.72383483022E-01 4.77216519629E-01 4.82100910849E-01 4.87037267215E-01 4.92026197567E-01 4.97068347820E-01 5.02164338831E-01 5.07314824133E-01 5.12520468592E-01 5.17781945922E-01 5.23099905882E-01 5.28475075813E-01 5.33908152077E-01 5.39399819009E-01 5.44950826148E-01 5.50561909903E-01 5.56233816289E-01 5.61967306874E-01 5.67763167244E-01 5.73622176881E-01 5.79545134306E-01 5.85532873563E-01 5.91586201973E-01 5.97705990576E-01 6.03893088010E-01 6.10148372191E-01 6.16472737221E-01 6.22867097769E-01 6.29332371564E-01 6.35869509439E-01 6.42479472654E-01 6.49163225459E-01 6.55921786148E-01 6.62756172073E-01 6.69667407005E-01 6.76656569494E-01 6.83724718595E-01 6.90872967475E-01 6.98102439827E-01 7.05414262309E-01 7.12809639759E-01 7.20289735666E-01 7.27855776050E-01 7.35509015821E-01 7.43250717409E-01 7.51082166683E-01 7.59004709450E-01 7.67019695114E-01 7.75128495900E-01 7.83332542332E-01 7.91633268600E-01 8.00032150961E-01 8.08530716395E-01 8.17130490910E-01 8.25833065444E-01 8.34640056606E-01 8.43553119217E-01 8.52573944663E-01 8.61704266328E-01 8.70945859780E-01 8.80300536659E-01 8.89770163678E-01 8.99356639945E-01 9.09061915537E-01 9.18887991685E-01 9.28836910887E-01 9.38910780337E-01 9.49111727390E-01 9.59441989095E-01 9.69903790353E-01 9.80499465403E-01 9.91231384862E-01 1.00210197386E+00 1.01311373469E+00 1.02426923336E+00 1.03557108183E+00 1.04702197530E+00 1.05862468874E+00 1.07038204193E+00 1.08229695129E+00 1.09437238859E+00 1.10661142856E+00 1.11901719926E+00 1.13159294139E+00 1.14434194439E+00 1.15726761561E+00 1.17037343781E+00 1.18366298650E+00 1.19713991884E+00 1.21080801654E+00 1.22467113756E+00 1.23873324558E+00 1.25299841827E+00 1.26747082073E+00 1.28215474610E+00 1.29705458561E+00 1.31217483251E+00 1.32752014444E+00 1.34309523275E+00 1.35890498198E+00 1.37495436754E+00 1.39124850238E+00 1.40779263251E+00 1.42459210755E+00 1.44165245744E+00 1.45897928376E+00 1.47657838388E+00 1.49445564555E+00 1.51261711514E+00 1.53106897708E+00 1.54981755520E+00 1.56886930519E+00 1.58823085208E+00 1.60790892811E+00 1.62791041953E+00 1.64824236401E+00 1.66891193216E+00 1.68992643302E+00 1.71129330363E+00 1.73302013413E+00 1.75511463585E+00 1.77758464291E+00 1.80043812675E+00 1.82368316508E+00 1.84732795130E+00 1.87138079360E+00 1.89585008354E+00 1.92074432037E+00 1.94607207034E+00 1.97184198230E+00 1.99806274626E+00 2.02474310745E+00 2.05189183915E+00 2.07951772666E+00 2.10762955089E+00 2.13623606234E+00 2.16534597302E+00 2.19496792206E+00 2.22511045059E+00 2.25578197640E+00 2.28699076106E+00 2.31874488790E+00 2.35105220325E+00 2.38392029958E+00 2.41735646450E+00 2.45136764135E+00 2.48596036949E+00 2.52114075058E+00 2.55691437446E+00 2.59328626298E+00 2.63026082841E+00 2.66784176833E+00 2.70603204119E+00 2.74483372323E+00 2.78424800198E+00 2.82427502896E+00 2.86491385503E+00 2.90616232611E+00 2.94801697798E+00 2.99047293175E+00 3.03352376515E+00 3.07716140522E+00 3.12137598481E+00 3.16615570939E+00 3.21148672394E+00 3.25735294635E+00 3.30373591896E+00 3.35061464948E+00 3.39796541727E+00 3.44576161117E+00 3.49397353624E+00 3.54256821342E+00 3.59150918666E+00 3.64075629696E+00 3.69026547667E+00 3.73998851441E+00 3.78987282679E+00 3.83986122672E+00 3.88989165602E+00 3.93989696114E+00 3.98980460880E+00 4.03953644918E+00 4.08900842716E+00 4.13813033720E+00 4.18680552789E+00 4.23493065111E+00 4.28239537834E+00 4.32908212576E+00 4.37486580156E+00 4.41961353986E+00 4.46318443383E+00 4.50542929660E+00 4.54619043219E+00 4.58530139598E+00 4.62258680489E+00 4.65786214557E+00 4.69093359929E+00 4.72159791624E+00 4.74964230022E+00 4.77484432531E+00 4.79697190653E+00 4.81578329646E+00 4.83102712447E+00 4.84244251203E+00 4.84975921485E+00 4.85269784193E+00 4.85097014502E+00 4.84427936769E+00 4.83232068502E+00 4.81478172807E+00 4.79134319182E+00 4.76167954994E+00 4.72545986808E+00 4.68234874087E+00 4.63200733193E+00 4.57409454645E+00 4.50826834525E+00 4.43418717260E+00 4.35151156069E+00 4.25990585789E+00 4.15904012809E+00 4.04859221073E+00 3.92824993370E+00 3.79771352004E+00 3.65669814012E+00 3.50493666124E+00 3.34218255868E+00 3.16821300896E+00 2.98283214914E+00 2.78587451690E+00 2.57720864490E+00 2.35674081608E+00 2.12441896591E+00 1.88023672549E+00 1.62423757381E+00 1.35651910359E+00 1.07723736751E+00 7.86611279882E-01 4.84927049121E-01 1.72542615361E-01 -1.50107962792E-01 -4.82510181110E-01 -8.24064906971E-01 -1.17408435616E+00 -1.53178830403E+00 -1.89630059031E+00 -2.26664598785E+00 -2.64174749985E+00 -3.02042417573E+00 -3.40138953249E+00 -3.78325067096E+00 -4.16450819237E+00 -4.54355703267E+00 -4.91868830514E+00 -5.28809231446E+00 -5.64986283133E+00 -6.00200279861E+00 -6.34243158604E+00 -6.66899396213E+00 -6.97947091659E+00 -7.27159249893E+00 -7.54305281486E+00 -7.79152734382E+00 -8.01469270220E+00 -8.21024900028E+00 -8.37594488915E+00 -8.50960540888E+00 -8.60916266613E+00 -8.67268939191E+00 -8.69843529852E+00 -8.68486616811E+00 -8.63070543807E+00 -8.53497800998E+00 -8.39705581716E+00 -8.21670458032E+00 -7.99413093296E+00 -7.73002890290E+00 -7.42562443490E+00 -7.08271630691E+00 -6.70371139453E+00 -6.29165177170E+00 -5.85023057006E+00 -5.38379286383E+00 -4.89731709301E+00 -4.39637160443E+00 -3.88703986944E+00 -3.37580665306E+00 -2.86939600990E+00 -2.37455023662E+00 -1.89773697247E+00 -1.44476929365E+00 -1.02032097269E+00 -6.27315911536E-01 -2.66167135716E-01 6.42025756755E-02 3.59746586350E-01 6.14595629973E-01 8.22627995003E-01 9.77485836040E-01 1.07259492873E+00 1.10118702879E+00 1.05633540578E+00 9.30902867997E-01 7.18386324812E-01 4.05064129965E-01 4.70026411729E-02 -4.94612237747E-03 2.16061786382E-04 -3.04622751910E-04 -2.59172191784E-04 -2.69483607553E-04 -2.73685985155E-04 -2.77954176369E-04 -2.81691722853E-04 -2.84975553453E-04 -2.87815542442E-04 2 0 Beta L 865 1.06417880821E-03 1.07487402153E-03 1.08567672469E-03 1.09658799804E-03 1.10750358766E-03 1.11820042171E-03 1.13034436041E-03 1.14126319539E-03 1.15245462565E-03 1.16457460377E-03 1.17584043887E-03 1.18826253011E-03 1.19953273168E-03 1.21221137748E-03 1.22365859939E-03 1.23643818794E-03 1.24927481602E-03 1.26100286900E-03 1.27408120620E-03 1.28716307531E-03 1.29948973779E-03 1.31288096377E-03 1.32606937462E-03 1.33939430914E-03 1.35283824300E-03 1.36647094551E-03 1.38039191256E-03 1.39389018858E-03 1.40831585807E-03 1.42242024083E-03 1.43625065386E-03 1.45110786307E-03 1.46568188388E-03 1.48038358023E-03 1.49496281103E-03 1.51008469015E-03 1.52526490318E-03 1.54091556405E-03 1.55620683753E-03 1.57183536619E-03 1.58768517005E-03 1.60376680438E-03 1.61955295415E-03 1.63635246520E-03 1.65232765606E-03 1.66910597303E-03 1.68572597711E-03 1.70286185981E-03 1.72001236674E-03 1.73689536720E-03 1.75476091308E-03 1.77216901617E-03 1.78997143327E-03 1.80801459871E-03 1.82639029029E-03 1.84462758417E-03 1.86291945449E-03 1.88158962521E-03 1.90068211656E-03 1.91967652403E-03 1.93898564755E-03 1.95854000216E-03 1.97817206545E-03 1.99827040367E-03 2.01822110242E-03 2.03841599968E-03 2.05900166524E-03 2.07966879736E-03 2.10036044234E-03 2.12177680951E-03 2.14304196973E-03 2.16433367426E-03 2.18624500819E-03 2.20799501166E-03 2.23028858746E-03 2.25294093373E-03 2.27545597551E-03 2.29812503335E-03 2.32145076627E-03 2.34487903908E-03 2.36839419123E-03 2.39222430731E-03 2.41635778247E-03 2.44030843716E-03 2.46498115318E-03 2.48960599789E-03 2.51501211386E-03 2.54005539507E-03 2.56535439735E-03 2.59120796381E-03 2.61744825782E-03 2.64379006008E-03 2.67034539816E-03 2.69723978943E-03 2.72420766672E-03 2.75173805304E-03 2.77941490817E-03 2.80709916277E-03 2.83555745035E-03 2.86408932369E-03 2.89278847513E-03 2.92182393185E-03 2.95120300943E-03 2.98082331211E-03 3.01068926703E-03 3.04099058681E-03 3.07159095185E-03 3.10250843780E-03 3.13353676796E-03 3.16517861235E-03 3.19688560014E-03 3.22914713073E-03 3.26163673408E-03 3.29428729335E-03 3.32742925942E-03 3.36074911608E-03 3.39465473932E-03 3.42873470568E-03 3.46318655902E-03 3.49789140498E-03 3.53322018790E-03 3.56861651693E-03 3.60456737921E-03 3.64068425780E-03 3.67748850607E-03 3.71429462860E-03 3.75171014746E-03 3.78941668654E-03 3.82732129231E-03 3.86592021299E-03 3.90482271878E-03 3.94386258347E-03 3.98372697767E-03 4.02364129371E-03 4.06416149712E-03 4.10493212773E-03 4.14629977860E-03 4.18794806880E-03 4.22981032666E-03 4.27246534070E-03 4.31551335892E-03 4.35884540896E-03 4.40254547413E-03 4.44702703636E-03 4.49151157215E-03 4.53664689375E-03 4.58230728044E-03 4.62830595069E-03 4.67486124289E-03 4.72186077738E-03 4.76932608239E-03 4.81719215878E-03 4.86567403427E-03 4.91450058988E-03 4.96391568575E-03 5.01379570322E-03 5.06425014248E-03 5.11507778570E-03 5.16658226651E-03 5.21838631331E-03 5.27102074825E-03 5.32382516955E-03 5.37738033716E-03 5.43141362823E-03 5.48601660612E-03 5.54112023645E-03 5.59692937236E-03 5.65310218517E-03 5.70991889620E-03 5.76726827458E-03 5.82529762561E-03 5.88379353544E-03 5.94289552381E-03 6.00268385365E-03 6.06293285972E-03 6.12389999183E-03 6.18555460849E-03 6.24755105147E-03 6.31051340682E-03 6.37376098357E-03 6.43795927107E-03 6.50260055356E-03 6.56790074900E-03 6.63394990988E-03 6.70059949487E-03 6.76795907955E-03 6.83595718294E-03 6.90474193823E-03 6.97407659894E-03 7.04419474638E-03 7.11496551678E-03 7.18654086798E-03 7.25865613726E-03 7.33177900914E-03 7.40529082457E-03 7.47974755854E-03 7.55493933651E-03 7.63089552976E-03 7.70757824990E-03 7.78510677800E-03 7.86329470469E-03 7.94232953364E-03 8.02209447332E-03 8.10279875458E-03 8.18419818680E-03 8.26648688750E-03 8.34943169854E-03 8.43347163884E-03 8.51816782936E-03 8.60383298886E-03 8.69028124931E-03 8.77763101420E-03 8.86581503327E-03 8.95492283919E-03 9.04493144419E-03 9.13579006208E-03 9.22768074997E-03 9.32037720459E-03 9.41409409649E-03 9.50866038427E-03 9.60422268972E-03 9.70076430602E-03 9.79825633981E-03 9.89677532233E-03 9.99618018587E-03 1.00966329374E-02 1.01981890480E-02 1.03006456043E-02 1.04041613437E-02 1.05087672909E-02 1.06143321925E-02 1.07210271397E-02 1.08287325000E-02 1.09376290834E-02 1.10475363788E-02 1.11585554930E-02 1.12707284152E-02 1.13839713886E-02 1.14984386946E-02 1.16139513160E-02 1.17306767078E-02 1.18485839976E-02 1.19676404799E-02 1.20879203716E-02 1.22094299593E-02 1.23321427829E-02 1.24560593225E-02 1.25813059485E-02 1.27076695492E-02 1.28354211560E-02 1.29644228363E-02 1.30947216507E-02 1.32262861923E-02 1.33592707075E-02 1.34935465586E-02 1.36291230263E-02 1.37661506924E-02 1.39044330289E-02 1.40442522105E-02 1.41853353525E-02 1.43279755118E-02 1.44718968352E-02 1.46173798110E-02 1.47643142901E-02 1.49126506894E-02 1.50625803172E-02 1.52139385457E-02 1.53668452319E-02 1.55213119363E-02 1.56772773623E-02 1.58348647421E-02 1.59940127293E-02 1.61547383035E-02 1.63171144056E-02 1.64811139551E-02 1.66467468333E-02 1.68140332424E-02 1.69830485530E-02 1.71537267366E-02 1.73261275885E-02 1.75002797381E-02 1.76761384151E-02 1.78538102036E-02 1.80332593359E-02 1.82144472242E-02 1.83975743702E-02 1.85824439484E-02 1.87692181693E-02 1.89578263901E-02 1.91483878594E-02 1.93408330696E-02 1.95352319061E-02 1.97315727277E-02 1.99299006343E-02 2.01301927827E-02 2.03325059497E-02 2.05368647277E-02 2.07432506194E-02 2.09517385522E-02 2.11623347454E-02 2.13750061076E-02 2.15898332868E-02 2.18068382293E-02 2.20259860978E-02 2.22474075274E-02 2.24709821624E-02 2.26968419428E-02 2.29249705972E-02 2.31553591620E-02 2.33880942208E-02 2.36231595711E-02 2.38605858861E-02 2.41004123608E-02 2.43425949460E-02 2.45872978489E-02 2.48344066399E-02 2.50840191226E-02 2.53361284504E-02 2.55907926641E-02 2.58479805960E-02 2.61077934488E-02 2.63701455631E-02 2.66352380987E-02 2.69029219053E-02 2.71733327053E-02 2.74464314788E-02 2.77223058364E-02 2.80009271855E-02 2.82823884165E-02 2.85666320523E-02 2.88537675289E-02 2.91437504751E-02 2.94367008886E-02 2.97325453035E-02 3.00314075082E-02 3.03332443942E-02 3.06381347907E-02 3.09460733645E-02 3.12571085875E-02 3.15712834046E-02 3.18886107253E-02 3.22091336639E-02 3.25328560887E-02 3.28598596827E-02 3.31901493293E-02 3.35237128179E-02 3.38606912929E-02 3.42010165731E-02 3.45448076927E-02 3.48920065921E-02 3.52427118784E-02 3.55969646172E-02 3.59547496892E-02 3.63161590179E-02 3.66811785662E-02 3.70498734415E-02 3.74222814732E-02 3.77984369973E-02 3.81783707575E-02 3.85621059860E-02 3.89497257706E-02 3.93412537600E-02 3.97366736920E-02 4.01361072016E-02 4.05395393128E-02 4.09470326868E-02 4.13586253216E-02 4.17743491295E-02 4.21942600633E-02 4.26183885260E-02 4.30467900746E-02 4.34794818196E-02 4.39165321326E-02 4.43579943912E-02 4.48038771118E-02 4.52542495241E-02 4.57091485219E-02 4.61686303710E-02 4.66327051363E-02 4.71014754818E-02 4.75749505271E-02 4.80532035795E-02 4.85362500703E-02 4.90241364547E-02 4.95169660828E-02 5.00147267378E-02 5.05175202526E-02 5.10253389270E-02 5.15382845470E-02 5.20563728598E-02 5.25796764712E-02 5.31082546212E-02 5.36421466000E-02 5.41814072955E-02 5.47260859125E-02 5.52762436259E-02 5.58319607198E-02 5.63932336252E-02 5.69601638360E-02 5.75327933671E-02 5.81111891848E-02 5.86954090841E-02 5.92854926075E-02 5.98815268342E-02 6.04835529540E-02 6.10916251822E-02 6.17058142574E-02 6.23262050917E-02 6.29528134451E-02 6.35857453750E-02 6.42250304059E-02 6.48707550199E-02 6.55229804039E-02 6.61817660572E-02 6.68471755797E-02 6.75192811802E-02 6.81981666724E-02 6.88838573817E-02 6.95764621403E-02 7.02760505748E-02 7.09826531362E-02 7.16963866022E-02 7.24172971189E-02 7.31454649121E-02 7.38809621302E-02 7.46238561890E-02 7.53742387568E-02 7.61321725858E-02 7.68977288433E-02 7.76710010482E-02 7.84520479205E-02 7.92409647667E-02 8.00378352303E-02 8.08427153291E-02 8.16556922015E-02 8.24768664014E-02 8.33063067486E-02 8.41441033938E-02 8.49903337108E-02 8.58450842455E-02 8.67084470199E-02 8.75805004695E-02 8.84613430138E-02 8.93510458213E-02 9.02497322592E-02 9.11574605713E-02 9.20743301834E-02 9.30004330104E-02 9.39358770219E-02 9.48807420967E-02 9.58351207407E-02 9.67991245570E-02 9.77728369067E-02 9.87563678139E-02 9.97498129162E-02 1.00753253347E-01 1.01766828921E-01 1.02790609075E-01 1.03824715497E-01 1.04869242042E-01 1.05924307307E-01 1.06989997532E-01 1.08066439040E-01 1.09153741984E-01 1.10252004715E-01 1.11361336802E-01 1.12481870864E-01 1.13613692742E-01 1.14756940589E-01 1.15911719230E-01 1.17078151462E-01 1.18256352520E-01 1.19446442066E-01 1.20648537359E-01 1.21862770042E-01 1.23089257474E-01 1.24328118978E-01 1.25579499384E-01 1.26843497113E-01 1.28120269586E-01 1.29409929092E-01 1.30712619646E-01 1.32028458970E-01 1.33357594635E-01 1.34700154700E-01 1.36056280945E-01 1.37426106220E-01 1.38809783439E-01 1.40207437315E-01 1.41619218890E-01 1.43045273681E-01 1.44485743501E-01 1.45940781198E-01 1.47410533370E-01 1.48895151394E-01 1.50394785688E-01 1.51909589606E-01 1.53439724306E-01 1.54985339804E-01 1.56546604357E-01 1.58123668528E-01 1.59716698411E-01 1.61325867215E-01 1.62951323692E-01 1.64593244181E-01 1.66251808495E-01 1.67927169318E-01 1.69619508674E-01 1.71329008068E-01 1.73055831392E-01 1.74800167546E-01 1.76562194639E-01 1.78342096063E-01 1.80140053274E-01 1.81956261902E-01 1.83790893975E-01 1.85644159561E-01 1.87516240538E-01 1.89407335212E-01 1.91317644422E-01 1.93247357372E-01 1.95196687271E-01 1.97165834612E-01 1.99155003932E-01 2.01164408366E-01 2.03194253335E-01 2.05244754406E-01 2.07316128548E-01 2.09408594164E-01 2.11522372356E-01 2.13657681679E-01 2.15814754031E-01 2.17993815124E-01 2.20195095814E-01 2.22418831142E-01 2.24665257901E-01 2.26934614744E-01 2.29227139412E-01 2.31543080796E-01 2.33882689986E-01 2.36246206853E-01 2.38633898505E-01 2.41046007295E-01 2.43482804402E-01 2.45944544656E-01 2.48431497581E-01 2.50943933027E-01 2.53482118685E-01 2.56046332449E-01 2.58636854235E-01 2.61253963516E-01 2.63897947422E-01 2.66569095140E-01 2.69267696575E-01 2.71994052594E-01 2.74748458321E-01 2.77531218567E-01 2.80342642598E-01 2.83183042893E-01 2.86052726023E-01 2.88952021420E-01 2.91881250506E-01 2.94840732483E-01 2.97830805543E-01 3.00851804947E-01 3.03904069853E-01 3.06987944340E-01 3.10103780210E-01 3.13251928396E-01 3.16432745938E-01 3.19646600722E-01 3.22893853924E-01 3.26174885241E-01 3.29490069132E-01 3.32839788756E-01 3.36224432756E-01 3.39644396134E-01 3.43100075524E-01 3.46591877475E-01 3.50120212164E-01 3.53685491229E-01 3.57288142005E-01 3.60928592279E-01 3.64607272056E-01 3.68324627280E-01 3.72081098964E-01 3.75877143722E-01 3.79713221434E-01 3.83589793394E-01 3.87507342913E-01 3.91466342262E-01 3.95467281276E-01 3.99510658230E-01 4.03596973595E-01 4.07726734598E-01 4.11900465134E-01 4.16118690292E-01 4.20381941377E-01 4.24690765814E-01 4.29045712055E-01 4.33447339903E-01 4.37896223006E-01 4.42392934370E-01 4.46938064634E-01 4.51532211021E-01 4.56175980788E-01 4.60869990534E-01 4.65614867836E-01 4.70411251016E-01 4.75259787376E-01 4.80161138395E-01 4.85115973301E-01 4.90124974051E-01 4.95188835311E-01 5.00308261585E-01 5.05483973427E-01 5.10716695164E-01 5.16007179357E-01 5.21356173007E-01 5.26764450878E-01 5.32232795385E-01 5.37762001056E-01 5.43352880873E-01 5.49006262282E-01 5.54722982050E-01 5.60503896252E-01 5.66349879278E-01 5.72261813699E-01 5.78240604516E-01 5.84287167302E-01 5.90402441345E-01 5.96587375251E-01 6.02842943371E-01 6.09170127670E-01 6.15569936481E-01 6.22043392511E-01 6.28591537116E-01 6.35215427008E-01 6.41916145677E-01 6.48694789471E-01 6.55552475507E-01 6.62490343464E-01 6.69509547663E-01 6.76611267920E-01 6.83796700705E-01 6.91067059638E-01 6.98423592366E-01 7.05867549158E-01 7.13400215547E-01 7.21022888702E-01 7.28736889983E-01 7.36543562808E-01 7.44444263867E-01 7.52440383656E-01 7.60533315630E-01 7.68724489740E-01 7.77015342523E-01 7.85407335014E-01 7.93901946368E-01 8.02500673172E-01 8.11205026489E-01 8.20016541206E-01 8.28936757910E-01 8.37967234725E-01 8.47109545532E-01 8.56365273804E-01 8.65736012849E-01 8.75223361858E-01 8.84828931504E-01 8.94554333941E-01 9.04401181870E-01 9.14371091230E-01 9.24465671186E-01 9.34686525363E-01 9.45035250020E-01 9.55513423936E-01 9.66122613448E-01 9.76864359741E-01 9.87740181361E-01 9.98751561168E-01 1.00989994838E+00 1.02118674935E+00 1.03261332132E+00 1.04418096591E+00 1.05589092015E+00 1.06774435212E+00 1.07974234966E+00 1.09188591120E+00 1.10417593681E+00 1.11661321696E+00 1.12919842433E+00 1.14193209533E+00 1.15481462333E+00 1.16784624232E+00 1.18102701376E+00 1.19435680782E+00 1.20783529180E+00 1.22146190743E+00 1.23523585290E+00 1.24915606928E+00 1.26322120908E+00 1.27742962729E+00 1.29177933957E+00 1.30626801830E+00 1.32089294964E+00 1.33565101365E+00 1.35053865324E+00 1.36555184337E+00 1.38068605996E+00 1.39593624273E+00 1.41129676373E+00 1.42676138604E+00 1.44232322563E+00 1.45797471316E+00 1.47370754680E+00 1.48951265026E+00 1.50538012808E+00 1.52129921150E+00 1.53725821332E+00 1.55324447457E+00 1.56924430920E+00 1.58524295152E+00 1.60122449448E+00 1.61717183416E+00 1.63306660636E+00 1.64888912562E+00 1.66461832358E+00 1.68023167813E+00 1.69570515479E+00 1.71101313214E+00 1.72612834092E+00 1.74102178933E+00 1.75566270113E+00 1.77001844034E+00 1.78405444909E+00 1.79773417704E+00 1.81101901407E+00 1.82386822983E+00 1.83623891049E+00 1.84808589608E+00 1.85936172641E+00 1.87001659076E+00 1.87999827555E+00 1.88925212676E+00 1.89772101285E+00 1.90534529328E+00 1.91206280180E+00 1.91780883358E+00 1.92251614245E+00 1.92611495393E+00 1.92853298678E+00 1.92969548719E+00 1.92952528531E+00 1.92794286018E+00 1.92486642694E+00 1.92021204465E+00 1.91389374155E+00 1.90582366631E+00 1.89591226367E+00 1.88406847396E+00 1.87019996300E+00 1.85421337985E+00 1.83601464938E+00 1.81550929391E+00 1.79260279165E+00 1.76720097471E+00 1.73921045854E+00 1.70853912008E+00 1.67509661002E+00 1.63879491176E+00 1.59954894420E+00 1.55727720593E+00 1.51190247178E+00 1.46335252832E+00 1.41156096216E+00 1.35646799101E+00 1.29802134284E+00 1.23617717834E+00 1.17090106044E+00 1.10216896329E+00 1.02996832200E+00 9.54299119069E-01 8.75175005411E-01 7.92624446670E-01 7.06691895850E-01 6.17438982561E-01 5.24945711605E-01 4.29311663683E-01 3.30657190722E-01 2.29124589940E-01 1.24879253851E-01 1.81107723606E-02 -9.09660175487E-02 -2.02110055636E-01 -3.15053172349E-01 -4.29499312705E-01 -5.45123888110E-01 -6.61573281287E-01 -7.78464528533E-01 -8.95385203968E-01 -1.01189353510E+00 -1.12751878203E+00 -1.24176190529E+00 -1.35409656697E+00 -1.46397048969E+00 -1.57080722004E+00 -1.67400832820E+00 -1.77295608964E+00 -1.86701668482E+00 -1.95554396139E+00 -2.03788379667E+00 -2.11337910403E+00 -2.18137551547E+00 -2.24122777915E+00 -2.29230689595E+00 -2.33400802266E+00 -2.36575914641E+00 -2.38703054035E+00 -2.39734497411E+00 -2.39628865530E+00 -2.38352283210E+00 -2.35879597540E+00 -2.32195640549E+00 -2.27296519887E+00 -2.21190914116E+00 -2.13901343814E+00 -2.05465381276E+00 -1.95936752390E+00 -1.85386273217E+00 -1.73902550893E+00 -1.61592362837E+00 -1.48580610125E+00 -1.35009720074E+00 -1.21038347359E+00 -1.06839194834E+00 -9.25957398544E-01 -7.84976133685E-01 -6.47343309955E-01 -5.14870219501E-01 -3.89177371532E-01 -2.71558442717E-01 -1.62809304695E-01 -6.30153406194E-02 2.81566985714E-02 1.09589120525E-01 1.79650941433E-01 2.36642457977E-01 2.78799837314E-01 3.04300657473E-01 3.11270161494E-01 2.97791185275E-01 2.61889549401E-01 2.01770611120E-01 1.13619116410E-01 1.31738218373E-02 -1.38067739603E-03 6.54388352054E-05 -8.05952419941E-05 -6.80138104445E-05 -7.10519272544E-05 -7.23752942299E-05 -7.37138443642E-05 -7.49004238547E-05 -7.59565530932E-05 -7.68849760664E-05 3 1 Beta L 865 -1.11548385923E-05 -1.13801812933E-05 -1.16100762194E-05 -1.18446153317E-05 -1.20838924489E-05 -1.23280032851E-05 -1.25770454881E-05 -1.28311186779E-05 -1.30903244873E-05 -1.33547666021E-05 -1.36245508028E-05 -1.38997850067E-05 -1.41805793111E-05 -1.44670460377E-05 -1.47592997769E-05 -1.50574574341E-05 -1.53616382766E-05 -1.56719639807E-05 -1.59885586809E-05 -1.63115490195E-05 -1.66410641968E-05 -1.69772360234E-05 -1.73201989727E-05 -1.76700902344E-05 -1.80270497698E-05 -1.83912203676E-05 -1.87627477009E-05 -1.91417803857E-05 -1.95284700402E-05 -1.99229713455E-05 -2.03254421076E-05 -2.07360433202E-05 -2.11549392293E-05 -2.15822973990E-05 -2.20182887785E-05 -2.24630877701E-05 -2.29168722996E-05 -2.33798238869E-05 -2.38521277190E-05 -2.43339727239E-05 -2.48255516460E-05 -2.53270611238E-05 -2.58387017679E-05 -2.63606782414E-05 -2.68931993421E-05 -2.74364780858E-05 -2.79907317914E-05 -2.85561821679E-05 -2.91330554032E-05 -2.97215822545E-05 -3.03219981407E-05 -3.09345432363E-05 -3.14998093148E-05 -3.21341060548E-05 -3.27847183377E-05 -3.34486551745E-05 -3.41282016043E-05 -3.48127178568E-05 -3.55234467699E-05 -3.62398256286E-05 -3.69748298386E-05 -3.77203600478E-05 -3.84870632240E-05 -3.92637832876E-05 -4.00612638126E-05 -4.08661060718E-05 -4.16952508115E-05 -4.25383813281E-05 -4.34029453809E-05 -4.42754905529E-05 -4.51737270090E-05 -4.60863037520E-05 -4.70242456553E-05 -4.79686715977E-05 -4.89404452801E-05 -4.99307180350E-05 -5.09414414529E-05 -5.19728137196E-05 -5.30184064584E-05 -5.40955854651E-05 -5.52398560328E-05 -5.63576237142E-05 -5.74968810626E-05 -5.86548960312E-05 -5.98438385585E-05 -6.10510264227E-05 -6.22857556724E-05 -6.35445512172E-05 -6.48276065096E-05 -6.61371253407E-05 -6.74728000930E-05 -6.88357056078E-05 -7.02277168982E-05 -7.16473216961E-05 -7.30943879122E-05 -7.45703973541E-05 -7.60783884933E-05 -7.76131665191E-05 -7.91815414388E-05 -8.07825050850E-05 -8.24145590622E-05 -8.40794110583E-05 -8.57777411310E-05 -8.75117194254E-05 -8.92784726934E-05 -9.10816209735E-05 -9.29241189492E-05 -9.47986300740E-05 -9.67161599966E-05 -9.86703038298E-05 -1.00663368685E-04 -1.02696132952E-04 -1.04771781218E-04 -1.06887447563E-04 -1.09048524039E-04 -1.11249839528E-04 -1.13498569676E-04 -1.15792705673E-04 -1.18131419382E-04 -1.20516799779E-04 -1.22951355174E-04 -1.25436730271E-04 -1.27969349910E-04 -1.30555822593E-04 -1.33193194408E-04 -1.35885026021E-04 -1.38629966877E-04 -1.41431336518E-04 -1.44288172650E-04 -1.47201736525E-04 -1.50175294674E-04 -1.53211048665E-04 -1.56305005307E-04 -1.59462459361E-04 -1.62684806781E-04 -1.65972720262E-04 -1.69325125476E-04 -1.72745960312E-04 -1.76235813671E-04 -1.79793822025E-04 -1.83428192037E-04 -1.87133295664E-04 -1.90913247548E-04 -1.94770865038E-04 -1.98704096292E-04 -2.02721300916E-04 -2.06815219600E-04 -2.10991842092E-04 -2.15255989971E-04 -2.19605160729E-04 -2.24041429382E-04 -2.28567127712E-04 -2.33185343232E-04 -2.37894494683E-04 -2.42701657795E-04 -2.47605469588E-04 -2.52607352882E-04 -2.57710029159E-04 -2.62916960046E-04 -2.68228408701E-04 -2.73644655808E-04 -2.79174973308E-04 -2.84814198902E-04 -2.90568351402E-04 -2.96439471833E-04 -3.02426260239E-04 -3.08534192148E-04 -3.14772163793E-04 -3.21127949240E-04 -3.27616393968E-04 -3.34235695240E-04 -3.40988026824E-04 -3.47873154544E-04 -3.54903693187E-04 -3.62072564366E-04 -3.69387036443E-04 -3.76851756495E-04 -3.84461036546E-04 -3.92229280653E-04 -4.00152384579E-04 -4.08238560296E-04 -4.16485915463E-04 -4.24895695453E-04 -4.33481969295E-04 -4.42235485437E-04 -4.51174540255E-04 -4.60286267645E-04 -4.69584606660E-04 -4.79073900471E-04 -4.88749934521E-04 -4.98625202367E-04 -5.08696700118E-04 -5.18973497741E-04 -5.29459165987E-04 -5.40151763351E-04 -5.51066260108E-04 -5.62196781342E-04 -5.73556240570E-04 -5.85139397331E-04 -5.96963941374E-04 -6.09022136949E-04 -6.21325924976E-04 -6.33878831221E-04 -6.46683549235E-04 -6.59747392256E-04 -6.73074854638E-04 -6.86671961422E-04 -7.00544201189E-04 -7.14695275800E-04 -7.29134256185E-04 -7.43863890598E-04 -7.58890609269E-04 -7.74219118145E-04 -7.89863031052E-04 -8.05815710322E-04 -8.22097885847E-04 -8.38704734957E-04 -8.55645424892E-04 -8.72933859257E-04 -8.90567233062E-04 -9.08558324214E-04 -9.26910949763E-04 -9.45635456612E-04 -9.64740123238E-04 -9.84228460958E-04 -1.00411428890E-03 -1.02439468029E-03 -1.04509268751E-03 -1.06620276471E-03 -1.08774195826E-03 -1.10971567879E-03 -1.13213543076E-03 -1.15500329487E-03 -1.17833798120E-03 -1.20214109569E-03 -1.22642667397E-03 -1.25120258597E-03 -1.27647772708E-03 -1.30226465149E-03 -1.32857252826E-03 -1.35541149450E-03 -1.38279111565E-03 -1.41072747306E-03 -1.43922397104E-03 -1.46829938498E-03 -1.49795887710E-03 -1.52822196792E-03 -1.55909208641E-03 -1.59058867544E-03 -1.62272105233E-03 -1.65550325389E-03 -1.68894520984E-03 -1.72306490637E-03 -1.75787348183E-03 -1.79338333941E-03 -1.82961270650E-03 -1.86657244001E-03 -1.90428007224E-03 -1.94274904135E-03 -1.98199552582E-03 -2.02203437390E-03 -2.06288249161E-03 -2.10455344713E-03 -2.14706796342E-03 -2.19044031251E-03 -2.23469265801E-03 -2.27983588446E-03 -2.32589107711E-03 -2.37287782003E-03 -2.42081241788E-03 -2.46971343962E-03 -2.51960638575E-03 -2.57050392539E-03 -2.62243229147E-03 -2.67540872799E-03 -2.72945562013E-03 -2.78459159359E-03 -2.84084570281E-03 -2.89823257548E-03 -2.95678154988E-03 -3.01650992474E-03 -3.07744818366E-03 -3.13961587487E-03 -3.20303916199E-03 -3.26774353625E-03 -3.33375540977E-03 -3.40110264145E-03 -3.46980703264E-03 -3.53990092907E-03 -3.61141053956E-03 -3.68436662152E-03 -3.75879331694E-03 -3.83472415841E-03 -3.91219034954E-03 -3.99122109412E-03 -4.07184600456E-03 -4.15410258890E-03 -4.23802061208E-03 -4.32363015333E-03 -4.41097226600E-03 -4.50008020800E-03 -4.59098375211E-03 -4.68372829198E-03 -4.77834043009E-03 -4.87486997335E-03 -4.97334782782E-03 -5.07381370891E-03 -5.17630749926E-03 -5.28087416162E-03 -5.38755123389E-03 -5.49638692438E-03 -5.60741836768E-03 -5.72069118477E-03 -5.83625629509E-03 -5.95415100473E-03 -6.07443121953E-03 -6.19713842266E-03 -6.32232421103E-03 -6.45004131477E-03 -6.58033621028E-03 -6.71326719312E-03 -6.84887534471E-03 -6.98723095953E-03 -7.12837712014E-03 -7.27237424526E-03 -7.41928201905E-03 -7.56915524576E-03 -7.72205867986E-03 -7.87804759739E-03 -8.03719099283E-03 -8.19954660429E-03 -8.36518005252E-03 -8.53416117968E-03 -8.70655672043E-03 -8.88243459609E-03 -9.06186325718E-03 -9.24491763909E-03 -9.43166865308E-03 -9.62219627214E-03 -9.81656407456E-03 -1.00148653330E-02 -1.02171693242E-02 -1.04235594862E-02 -1.06341200698E-02 -1.08489313754E-02 -1.10680812715E-02 -1.12916629968E-02 -1.15197573677E-02 -1.17524604673E-02 -1.19898600438E-02 -1.22320580779E-02 -1.24791505761E-02 -1.27312288052E-02 -1.29884029332E-02 -1.32507688755E-02 -1.35184369348E-02 -1.37915078305E-02 -1.40700983319E-02 -1.43543136056E-02 -1.46442702345E-02 -1.49400843886E-02 -1.52418730404E-02 -1.55497568157E-02 -1.58638596394E-02 -1.61843071245E-02 -1.65112266126E-02 -1.68447489465E-02 -1.71850097806E-02 -1.75321403825E-02 -1.78862869934E-02 -1.82475801989E-02 -1.86161743133E-02 -1.89922145207E-02 -1.93758465394E-02 -1.97672292460E-02 -2.01665166872E-02 -2.05738668612E-02 -2.09894480675E-02 -2.14134149999E-02 -2.18460113701E-02 -2.22871309444E-02 -2.27374623914E-02 -2.31966676699E-02 -2.36653067132E-02 -2.41431845998E-02 -2.46309053241E-02 -2.51285507382E-02 -2.56359829773E-02 -2.61538375335E-02 -2.66821116912E-02 -2.72209025043E-02 -2.77711683418E-02 -2.83315256002E-02 -2.89043275796E-02 -2.94876701002E-02 -3.00838228220E-02 -3.06909874375E-02 -3.13109853787E-02 -3.19436898010E-02 -3.25886311526E-02 -3.32469379733E-02 -3.39183910347E-02 -3.46036823561E-02 -3.53024223264E-02 -3.60155963339E-02 -3.67427993802E-02 -3.74851327166E-02 -3.82422316036E-02 -3.90145511153E-02 -3.98025905650E-02 -4.06065896881E-02 -4.14265864215E-02 -4.22633233938E-02 -4.31170630529E-02 -4.39877860413E-02 -4.48761942228E-02 -4.57826247621E-02 -4.67073073107E-02 -4.76505664709E-02 -4.86129920243E-02 -4.95948748292E-02 -5.05964568222E-02 -5.16182335548E-02 -5.26609227451E-02 -5.37243794120E-02 -5.48094128877E-02 -5.59163430416E-02 -5.70456191188E-02 -5.81976968133E-02 -5.93730667366E-02 -6.05721303513E-02 -6.17954044646E-02 -6.30434117094E-02 -6.43165702332E-02 -6.56155030374E-02 -6.69404615546E-02 -6.82923977126E-02 -6.96717219015E-02 -7.10784773255E-02 -7.25138230455E-02 -7.39785804325E-02 -7.54718692545E-02 -7.69965915065E-02 -7.85511742125E-02 -8.01373752756E-02 -8.17556530337E-02 -8.34066287890E-02 -8.50909924898E-02 -8.68089978874E-02 -8.85619662415E-02 -9.03505599421E-02 -9.21746076646E-02 -9.40359668974E-02 -9.59348910872E-02 -9.78718290702E-02 -9.98481052885E-02 -1.01864322627E-01 -1.03920869929E-01 -1.06019332978E-01 -1.08159903832E-01 -1.10343700291E-01 -1.12571796974E-01 -1.14844339202E-01 -1.17163439154E-01 -1.19528749706E-01 -1.21941985087E-01 -1.24403936686E-01 -1.26915711538E-01 -1.29477630103E-01 -1.32092149050E-01 -1.34758505569E-01 -1.37478948555E-01 -1.40254834276E-01 -1.43085691672E-01 -1.45974670342E-01 -1.48921037668E-01 -1.51927695092E-01 -1.54994347761E-01 -1.58122963207E-01 -1.61315165029E-01 -1.64571096675E-01 -1.67893237769E-01 -1.71281837596E-01 -1.74739200867E-01 -1.78266312899E-01 -1.81864300260E-01 -1.85534953040E-01 -1.89279528588E-01 -1.93099879904E-01 -1.96996872526E-01 -2.00972818651E-01 -2.05028702442E-01 -2.09166470003E-01 -2.13387435152E-01 -2.17693748283E-01 -2.22086800069E-01 -2.26568296606E-01 -2.31140304640E-01 -2.35804200011E-01 -2.40562364283E-01 -2.45416310761E-01 -2.50367995485E-01 -2.55419587938E-01 -2.60572950067E-01 -2.65829971054E-01 -2.71193295791E-01 -2.76664225226E-01 -2.82245732111E-01 -2.87939423868E-01 -2.93748008398E-01 -2.99673328833E-01 -3.05718277097E-01 -3.11884848224E-01 -3.18175521445E-01 -3.24593028799E-01 -3.31139539953E-01 -3.37818178956E-01 -3.44630869617E-01 -3.51581077195E-01 -3.58670978976E-01 -3.65903647237E-01 -3.73281851121E-01 -3.80808591036E-01 -3.88486812970E-01 -3.96319393831E-01 -4.04309721897E-01 -4.12460695590E-01 -4.20775714672E-01 -4.29257886993E-01 -4.37910783441E-01 -4.46737549900E-01 -4.55741907117E-01 -4.64927296484E-01 -4.74297309843E-01 -4.83855668913E-01 -4.93606278379E-01 -5.03552688884E-01 -5.13699088543E-01 -5.24049299644E-01 -5.34607474198E-01 -5.45377746203E-01 -5.56364320301E-01 -5.67571581632E-01 -5.79003872553E-01 -5.90665708761E-01 -6.02561576564E-01 -6.14696373923E-01 -6.27074520675E-01 -6.39701226758E-01 -6.52581143560E-01 -6.65719466454E-01 -6.79121313649E-01 -6.92791932109E-01 -7.06736587257E-01 -7.20960861407E-01 -7.35470157259E-01 -7.50270323512E-01 -7.65366923061E-01 -7.80765959364E-01 -7.96473432703E-01 -8.12495437783E-01 -8.28838202814E-01 -8.45508033504E-01 -8.62511532722E-01 -8.79855188771E-01 -8.97545709538E-01 -9.15590114384E-01 -9.33995188769E-01 -9.52768203610E-01 -9.71916325306E-01 -9.91447053854E-01 -1.01136779276E+00 -1.03168633711E+00 -1.05241047645E+00 -1.07354818584E+00 -1.09510761865E+00 -1.11709699516E+00 -1.13952483013E+00 -1.16239969483E+00 -1.18573035541E+00 -1.20952568232E+00 -1.23379487741E+00 -1.25854710149E+00 -1.28379185456E+00 -1.30953871466E+00 -1.33579748803E+00 -1.36257815724E+00 -1.38989084468E+00 -1.41774591655E+00 -1.44615391462E+00 -1.47512557060E+00 -1.50467173991E+00 -1.53480365386E+00 -1.56553254360E+00 -1.59686999757E+00 -1.62882770772E+00 -1.66141765130E+00 -1.69465198198E+00 -1.72854309153E+00 -1.76310352715E+00 -1.79834619615E+00 -1.83428406979E+00 -1.87093043881E+00 -1.90829885597E+00 -1.94640300501E+00 -1.98525690369E+00 -2.02487475415E+00 -2.06527102201E+00 -2.10646043213E+00 -2.14845789538E+00 -2.19127868621E+00 -2.23493820074E+00 -2.27945220330E+00 -2.32483664472E+00 -2.37110777466E+00 -2.41828205771E+00 -2.46637632054E+00 -2.51540753901E+00 -2.56539302590E+00 -2.61635036497E+00 -2.66829737775E+00 -2.72125219395E+00 -2.77523318819E+00 -2.83025902874E+00 -2.88634866258E+00 -2.94352128430E+00 -3.00179641069E+00 -3.06119377914E+00 -3.12173346922E+00 -3.18343576457E+00 -3.24632129251E+00 -3.31041088442E+00 -3.37572571342E+00 -3.44228716304E+00 -3.51011690693E+00 -3.57923690754E+00 -3.64966934277E+00 -3.72143665963E+00 -3.79456158823E+00 -3.86906706638E+00 -3.94497629075E+00 -4.02231268733E+00 -4.10109991358E+00 -4.18136184089E+00 -4.26312255695E+00 -4.34640635819E+00 -4.43123769164E+00 -4.51764123833E+00 -4.60564182474E+00 -4.69526440318E+00 -4.78653409899E+00 -4.87947617045E+00 -4.97411593395E+00 -5.07047882438E+00 -5.16859037210E+00 -5.26847608134E+00 -5.37016156630E+00 -5.47367236773E+00 -5.57903405922E+00 -5.68627210937E+00 -5.79541194657E+00 -5.90647884925E+00 -6.01949799520E+00 -6.13449429447E+00 -6.25149254336E+00 -6.37051715850E+00 -6.49159235641E+00 -6.61474191622E+00 -6.73998926008E+00 -6.86735734247E+00 -6.99686860571E+00 -7.12854493293E+00 -7.26240756611E+00 -7.39847706032E+00 -7.53677320618E+00 -7.67731496337E+00 -7.82012035153E+00 -7.96520643015E+00 -8.11258915869E+00 -8.26228331018E+00 -8.41430244405E+00 -8.56865867133E+00 -8.72536270881E+00 -8.88442364066E+00 -9.04584886375E+00 -9.20964395035E+00 -9.37581251997E+00 -9.54435610059E+00 -9.71527399163E+00 -9.88856311047E+00 -1.00642178416E+01 -1.02422298593E+01 -1.04225879741E+01 -1.06052779527E+01 -1.07902823049E+01 -1.09775801202E+01 -1.11671468505E+01 -1.13589540813E+01 -1.15529693507E+01 -1.17491558614E+01 -1.19474722941E+01 -1.21478725077E+01 -1.23503053335E+01 -1.25547142420E+01 -1.27610371086E+01 -1.29692059074E+01 -1.31791464013E+01 -1.33907778373E+01 -1.36040126296E+01 -1.38187559993E+01 -1.40349056647E+01 -1.42523514710E+01 -1.44709750022E+01 -1.46906492434E+01 -1.49112381787E+01 -1.51325963782E+01 -1.53545686267E+01 -1.55769894721E+01 -1.57996828478E+01 -1.60224615889E+01 -1.62451270508E+01 -1.64674686167E+01 -1.66892632818E+01 -1.69102751950E+01 -1.71302551821E+01 -1.73489403267E+01 -1.75660534690E+01 -1.77813028013E+01 -1.79943813635E+01 -1.82049666380E+01 -1.84127200978E+01 -1.86172867745E+01 -1.88182948513E+01 -1.90153552715E+01 -1.92080613495E+01 -1.93959884195E+01 -1.95786935222E+01 -1.97557150876E+01 -1.99265726914E+01 -2.00907668255E+01 -2.02477787312E+01 -2.03970702710E+01 -2.05380838688E+01 -2.06702424880E+01 -2.07929497308E+01 -2.09055899357E+01 -2.10075284533E+01 -2.10981119191E+01 -2.11766687068E+01 -2.12425094245E+01 -2.12949275757E+01 -2.13332003243E+01 -2.13565893869E+01 -2.13643420934E+01 -2.13556925947E+01 -2.13298632134E+01 -2.12860660163E+01 -2.12235045373E+01 -2.11413757012E+01 -2.10388719873E+01 -2.09151837807E+01 -2.07695019691E+01 -2.06010207854E+01 -2.04089408946E+01 -2.01924727486E+01 -1.99508402178E+01 -1.96832844992E+01 -1.93890683200E+01 -1.90674804242E+01 -1.87178403981E+01 -1.83395037571E+01 -1.79318673919E+01 -1.74943752925E+01 -1.70265246096E+01 -1.65278720147E+01 -1.59980403791E+01 -1.54367257318E+01 -1.48437045315E+01 -1.42188411821E+01 -1.35620958347E+01 -1.28735323899E+01 -1.21533267367E+01 -1.14017751355E+01 -1.06193027619E+01 -9.80647232914E+00 -8.96399274554E+00 -8.09272778761E+00 -7.19370466453E+00 -6.26812244988E+00 -5.31736028520E+00 -4.34298526017E+00 -3.34675987680E+00 -2.33064901062E+00 -1.29682619813E+00 -2.47679181790E-01 8.14185459263E-01 1.88593875153E+00 2.96452697959E+00 4.04667074726E+00 5.12886562730E+00 6.20738460238E+00 7.27828250005E+00 8.33740267749E+00 9.38038614911E+00 1.04026834525E+01 1.13995694698E+01 1.23661614899E+01 1.32974407922E+01 1.41882779907E+01 1.50334624462E+01 1.58277359928E+01 1.65658312330E+01 1.72425146383E+01 1.78526346581E+01 1.83911750022E+01 1.88533131997E+01 1.92344844939E+01 1.95304510022E+01 1.97373759992E+01 1.98519030155E+01 1.98712393026E+01 1.97932429472E+01 1.96165127597E+01 1.93404796663E+01 1.89654980236E+01 1.84929348327E+01 1.79252543013E+01 1.72660946038E+01 1.65203329673E+01 1.56941343709E+01 1.47949781139E+01 1.38316553878E+01 1.28142295571E+01 1.17539492741E+01 1.06631026270E+01 9.55479831315E+00 8.44265719745E+00 7.34039455599E+00 6.26126967205E+00 5.21737525138E+00 4.21873411153E+00 3.27216479552E+00 2.37987098200E+00 1.54153703162E+00 7.67283655990E-01 7.11100531245E-02 -5.32184238708E-01 -1.02702021676E+00 -1.39706901308E+00 -1.62528901863E+00 -1.69399106130E+00 -1.58474073546E+00 -1.27996852282E+00 -7.48055533366E-01 -8.96968998873E-02 9.02974679900E-03 -7.84685589814E-04 2.02080041177E-04 1.13521676543E-04 1.31555638519E-04 1.38568144769E-04 1.46270305958E-04 1.53504149994E-04 1.60391812157E-04 1.66928953966E-04 4 1 Beta L 865 1.03166542833E-05 1.05250645462E-05 1.07376849765E-05 1.09546006254E-05 1.11758982620E-05 1.14016664085E-05 1.16319953750E-05 1.18669772964E-05 1.21067061687E-05 1.23512778866E-05 1.26007902821E-05 1.28553431636E-05 1.31150383558E-05 1.33799797403E-05 1.36502732971E-05 1.39260271475E-05 1.42073515968E-05 1.44943591785E-05 1.47871646997E-05 1.50858852865E-05 1.53906404313E-05 1.57015520403E-05 1.60187444824E-05 1.63423446389E-05 1.66724819544E-05 1.70092884882E-05 1.73528989677E-05 1.77034508417E-05 1.80610843359E-05 1.84259425084E-05 1.87981713077E-05 1.91779196304E-05 1.95653393810E-05 1.99605855328E-05 2.03638161896E-05 2.07751926495E-05 2.11948794685E-05 2.16230445272E-05 2.20598590976E-05 2.25054979116E-05 2.29601392309E-05 2.34239649182E-05 2.38971605104E-05 2.43799152922E-05 2.48724223723E-05 2.53748787603E-05 2.58874854458E-05 2.64104474786E-05 2.69439740509E-05 2.74882785806E-05 2.80435787973E-05 2.86100968288E-05 2.91310635769E-05 2.97175995020E-05 3.03193301317E-05 3.09333897658E-05 3.15619535257E-05 3.21948473571E-05 3.28523592829E-05 3.35148340307E-05 3.41946601590E-05 3.48840901664E-05 3.55932875456E-05 3.63115838783E-05 3.70492345860E-05 3.77934281311E-05 3.85603406358E-05 3.93401048858E-05 4.01398265223E-05 4.09466419000E-05 4.17774614565E-05 4.26214289189E-05 4.34890668230E-05 4.43623237899E-05 4.52611224092E-05 4.61769963465E-05 4.71117981362E-05 4.80657047777E-05 4.90325616695E-05 5.00289481030E-05 5.10904091886E-05 5.21242321843E-05 5.31779867325E-05 5.42487684919E-05 5.53485655760E-05 5.64648739008E-05 5.76070119105E-05 5.87711952811E-05 5.99577917091E-05 6.11688150546E-05 6.24042271412E-05 6.36647052306E-05 6.49521249584E-05 6.62650560813E-05 6.76034789376E-05 6.89684830913E-05 7.03632368963E-05 7.17824735652E-05 7.32331776829E-05 7.47138403508E-05 7.62232622192E-05 7.77629243789E-05 7.93337700073E-05 8.09373956151E-05 8.25713595668E-05 8.42389886267E-05 8.59431115685E-05 8.76767142202E-05 8.94501881979E-05 9.12575478266E-05 9.31007446997E-05 9.49809000469E-05 9.69004805933E-05 9.88572117284E-05 1.00855830863E-04 1.02891800123E-04 1.04971549188E-04 1.07093345399E-04 1.09256251742E-04 1.11462410439E-04 1.13714032988E-04 1.16012698300E-04 1.18354888211E-04 1.20747165758E-04 1.23186269972E-04 1.25675904862E-04 1.28214514405E-04 1.30805524948E-04 1.33447594747E-04 1.36142237618E-04 1.38892300907E-04 1.41699936887E-04 1.44561542788E-04 1.47481629081E-04 1.50461872853E-04 1.53502744774E-04 1.56603288295E-04 1.59767085742E-04 1.62994685318E-04 1.66285151866E-04 1.69646711330E-04 1.73073257792E-04 1.76569190668E-04 1.80136883314E-04 1.83774628334E-04 1.87490028805E-04 1.91276268918E-04 1.95138934923E-04 1.99082863407E-04 2.03105130441E-04 2.07208115687E-04 2.11393635537E-04 2.15664972620E-04 2.20020162121E-04 2.24466167336E-04 2.29001513062E-04 2.33627500587E-04 2.38346865959E-04 2.43162479412E-04 2.48074815306E-04 2.53083901874E-04 2.58198923038E-04 2.63414273951E-04 2.68736073178E-04 2.74165981426E-04 2.79703014898E-04 2.85351828197E-04 2.91121300455E-04 2.96999292494E-04 3.03000356233E-04 3.09122250172E-04 3.15367222239E-04 3.21734734955E-04 3.28237288767E-04 3.34867316888E-04 3.41632224108E-04 3.48536055295E-04 3.55573507403E-04 3.62758044053E-04 3.70085777808E-04 3.77564443795E-04 3.85192027917E-04 3.92969830397E-04 4.00910954533E-04 4.09006580934E-04 4.17274080286E-04 4.25701153523E-04 4.34300752284E-04 4.43077101939E-04 4.52025893986E-04 4.61159344705E-04 4.70473898515E-04 4.79978545632E-04 4.89676240750E-04 4.99565382025E-04 5.09659797127E-04 5.19953858469E-04 5.30459785488E-04 5.41172552429E-04 5.52108653098E-04 5.63260653865E-04 5.74640046710E-04 5.86249658735E-04 5.98092253342E-04 6.10174434271E-04 6.22500362482E-04 6.35075806684E-04 6.47905650114E-04 6.60993356351E-04 6.74347377484E-04 6.87970262317E-04 7.01867698727E-04 7.16044435047E-04 7.30512851018E-04 7.45266768500E-04 7.60325504589E-04 7.75684526409E-04 7.91352076603E-04 8.07341637486E-04 8.23649852702E-04 8.40289164980E-04 8.57262578766E-04 8.74580128672E-04 8.92249212587E-04 9.10273177387E-04 9.28664777952E-04 9.47421191166E-04 9.66563919642E-04 9.86087747629E-04 1.00600837024E-03 1.02633099999E-03 1.04706606497E-03 1.06821545188E-03 1.08979683879E-03 1.11181117715E-03 1.13427202573E-03 1.15718612724E-03 1.18056204394E-03 1.20441122786E-03 1.22874231609E-03 1.25356444286E-03 1.27888666015E-03 1.30472382311E-03 1.33107896984E-03 1.35796955221E-03 1.38540031032E-03 1.41338936346E-03 1.44193978866E-03 1.47106954226E-03 1.50078745618E-03 1.53110630556E-03 1.56203530390E-03 1.59359102845E-03 1.62578408727E-03 1.65862545631E-03 1.69213251972E-03 1.72631488157E-03 1.76118896852E-03 1.79676734148E-03 1.83306457896E-03 1.87009481901E-03 1.90787336426E-03 1.94641302168E-03 1.98573270296E-03 2.02584589739E-03 2.06677292192E-03 2.10852398664E-03 2.15111822706E-03 2.19457432081E-03 2.23890676124E-03 2.28413309494E-03 2.33027685393E-03 2.37734969715E-03 2.42537583272E-03 2.47437145293E-03 2.52435687505E-03 2.57534961005E-03 2.62737650044E-03 2.68045102322E-03 2.73460026182E-03 2.78984026244E-03 2.84619931452E-03 2.90369525199E-03 2.96235255827E-03 3.02219457634E-03 3.08324592778E-03 3.14553227840E-03 3.20907376485E-03 3.27390024976E-03 3.34003618668E-03 3.40750985427E-03 3.47634360115E-03 3.54656833238E-03 3.61821327443E-03 3.69130495678E-03 3.76587108869E-03 3.84194627192E-03 3.91955811234E-03 3.99873408350E-03 4.07951265593E-03 4.16192431638E-03 4.24599653664E-03 4.33177148477E-03 4.41927352577E-03 4.50854899427E-03 4.59962645573E-03 4.69254228110E-03 4.78733373952E-03 4.88404221113E-03 4.98270242402E-03 5.08335926117E-03 5.18604658811E-03 5.29080689703E-03 5.39768723811E-03 5.50672202980E-03 5.61796304087E-03 5.73144869143E-03 5.84722645246E-03 5.96534552172E-03 6.08584839117E-03 6.20878952073E-03 6.33420613314E-03 6.46216416607E-03 6.59270269973E-03 6.72587800057E-03 6.86174519068E-03 7.00035485987E-03 7.14176702679E-03 7.28603275986E-03 7.43321586171E-03 7.58336973903E-03 7.73655484487E-03 7.89283622112E-03 8.05227528936E-03 8.21493493470E-03 8.38087847552E-03 8.55017508169E-03 8.72289053120E-03 8.89909875139E-03 9.07885824189E-03 9.26225566819E-03 9.44935497000E-03 9.64023306767E-03 9.83496831963E-03 1.00336344424E-02 1.02363131352E-02 1.04430905681E-02 1.06540413440E-02 1.08692543785E-02 1.10888106759E-02 1.13128047262E-02 1.15413254965E-02 1.17744567692E-02 1.20123011468E-02 1.22549467285E-02 1.25024960098E-02 1.27550416618E-02 1.30126921942E-02 1.32755443620E-02 1.35437062358E-02 1.38172853847E-02 1.40963895398E-02 1.43811307399E-02 1.46716231403E-02 1.49679832846E-02 1.52703286744E-02 1.55787804390E-02 1.58934639557E-02 1.62145006881E-02 1.65420258796E-02 1.68761600709E-02 1.72170461244E-02 1.75648185001E-02 1.79196115064E-02 1.82815724718E-02 1.86508435937E-02 1.90275710586E-02 1.94119105260E-02 1.98040047270E-02 2.02040833195E-02 2.06120308712E-02 2.10285159970E-02 2.14531939098E-02 2.18866058090E-02 2.23285475674E-02 2.27796036001E-02 2.32398423850E-02 2.37091157902E-02 2.41880351557E-02 2.46765956540E-02 2.51748668541E-02 2.56837772579E-02 2.62019810297E-02 2.67317338186E-02 2.72711969379E-02 2.78225444920E-02 2.83840400206E-02 2.89574168146E-02 2.95425573893E-02 3.01389924070E-02 3.07478012629E-02 3.13687584772E-02 3.20025231786E-02 3.26487126556E-02 3.33082623830E-02 3.39807636280E-02 3.46672834603E-02 3.53674433728E-02 3.60816753944E-02 3.68104500942E-02 3.75539860210E-02 3.83123044643E-02 3.90861083210E-02 3.98756436117E-02 4.06808703742E-02 4.15024555141E-02 4.23407079906E-02 4.31958386988E-02 4.40681423564E-02 4.49581731653E-02 4.58661984949E-02 4.67924328793E-02 4.77373413333E-02 4.87015973562E-02 4.96850451922E-02 5.06884512269E-02 5.17121003990E-02 5.27564141469E-02 5.38218132094E-02 5.49087478739E-02 5.60175909991E-02 5.71488220208E-02 5.83029225827E-02 5.94802761638E-02 6.06814683862E-02 6.19067122658E-02 6.31569129759E-02 6.44324434875E-02 6.57333149051E-02 6.70606289917E-02 6.84151692528E-02 6.97960224019E-02 7.12060186623E-02 7.26435697271E-02 7.41103677712E-02 7.56068273573E-02 7.71335222977E-02 7.86910889183E-02 8.02797392322E-02 8.19007314984E-02 8.35546796448E-02 8.52413627155E-02 8.69625767748E-02 8.87185180078E-02 9.05095887908E-02 9.23370399026E-02 9.42014243076E-02 9.61030708723E-02 9.80434953012E-02 1.00022833184E-01 1.02042135715E-01 1.04102404545E-01 1.06203739004E-01 1.08348144857E-01 1.10535242659E-01 1.12766665203E-01 1.15043109516E-01 1.17365626579E-01 1.19734480077E-01 1.22151987282E-01 1.24617383956E-01 1.27132786581E-01 1.29699464841E-01 1.32316919663E-01 1.34988134290E-01 1.37712370997E-01 1.40492364097E-01 1.43327794443E-01 1.46220498936E-01 1.49172000736E-01 1.52182383329E-01 1.55253983001E-01 1.58386993491E-01 1.61583576148E-01 1.64844627647E-01 1.68171174195E-01 1.71564892184E-01 1.75026926698E-01 1.78559002572E-01 1.82161905600E-01 1.85837785106E-01 1.89587539159E-01 1.93412970188E-01 1.97315283313E-01 2.01296480960E-01 2.05357836927E-01 2.09500918613E-01 2.13727655564E-01 2.18039293014E-01 2.22438053370E-01 2.26925320613E-01 2.31502900457E-01 2.36172801363E-01 2.40936743037E-01 2.45796458033E-01 2.50754409783E-01 2.55811772241E-01 2.60971314795E-01 2.66234500249E-01 2.71603847863E-01 2.77081035145E-01 2.82668758887E-01 2.88368841706E-01 2.94183569196E-01 3.00115482516E-01 3.06166555694E-01 3.12339705348E-01 3.18636669109E-01 3.25060679231E-01 3.31613721473E-01 3.38298637888E-01 3.45117985060E-01 3.52074530225E-01 3.59170990838E-01 3.66410013393E-01 3.73794738769E-01 3.81327825478E-01 3.89012419565E-01 3.96851377845E-01 4.04848005829E-01 4.13005189702E-01 4.21326373828E-01 4.29814724576E-01 4.38473554378E-01 4.47306293631E-01 4.56316549734E-01 4.65507584227E-01 4.74883266891E-01 4.84447115845E-01 4.94202962520E-01 5.04154612350E-01 5.14305943847E-01 5.24660996783E-01 5.35223773199E-01 5.45998434833E-01 5.56989107872E-01 5.68200320534E-01 5.79636126204E-01 5.91301340245E-01 6.03200233988E-01 6.15337602269E-01 6.27718154246E-01 6.40346724618E-01 6.53228157637E-01 6.66367599758E-01 6.79770018384E-01 6.93440807619E-01 7.07385077605E-01 7.21608361196E-01 7.36116181162E-01 7.50914145734E-01 7.66007986889E-01 7.81403505138E-01 7.97106781607E-01 8.13123781263E-01 8.29460674363E-01 8.46123925955E-01 8.63119767052E-01 8.80454894058E-01 8.98135891753E-01 9.16169662753E-01 9.34563008402E-01 9.53323101074E-01 9.72457100258E-01 9.91972337242E-01 1.01187630767E+00 1.03217656456E+00 1.05288093555E+00 1.07399729765E+00 1.09553370408E+00 1.11749830378E+00 1.13989955440E+00 1.16274586814E+00 1.18604597225E+00 1.20980866213E+00 1.23404294544E+00 1.25875798820E+00 1.28396308374E+00 1.30966774961E+00 1.33588166427E+00 1.36261467936E+00 1.38987675405E+00 1.41767820216E+00 1.44602932559E+00 1.47494076088E+00 1.50442323349E+00 1.53448773198E+00 1.56514540753E+00 1.59640762525E+00 1.62828589209E+00 1.66079204996E+00 1.69393798918E+00 1.72773589941E+00 1.76219820807E+00 1.79733745908E+00 1.83316650467E+00 1.86969836361E+00 1.90694629592E+00 1.94492379824E+00 1.98364453569E+00 2.02312251001E+00 2.06337182654E+00 2.10440693495E+00 2.14624245029E+00 2.18889326248E+00 2.23237445653E+00 2.27670145288E+00 2.32188980263E+00 2.36795536890E+00 2.41491426301E+00 2.46278281194E+00 2.51157762763E+00 2.56131554441E+00 2.61201366772E+00 2.66368935885E+00 2.71636020500E+00 2.77004409179E+00 2.82475910683E+00 2.88052365356E+00 2.93735632298E+00 2.99527602516E+00 3.05430185630E+00 3.11445323244E+00 3.17574976230E+00 3.23821132535E+00 3.30185807072E+00 3.36671034770E+00 3.43278875781E+00 3.50011416879E+00 3.56870764394E+00 3.63859049093E+00 3.70978423526E+00 3.78231062380E+00 3.85619160754E+00 3.93144934735E+00 4.00810620638E+00 4.08618469610E+00 4.16570755908E+00 4.24669768390E+00 4.32917808971E+00 4.41317197301E+00 4.49870267071E+00 4.58579359181E+00 4.67446827640E+00 4.76475037783E+00 4.85666354651E+00 4.95023156631E+00 5.04547817897E+00 5.14242719137E+00 5.24110234608E+00 5.34152738696E+00 5.44372595882E+00 5.54772165845E+00 5.65353787820E+00 5.76119796042E+00 5.87072494460E+00 5.98214174846E+00 6.09547094230E+00 6.21073483505E+00 6.32795537331E+00 6.44715410476E+00 6.56835214135E+00 6.69157008718E+00 6.81682800249E+00 6.94414533836E+00 7.07354088017E+00 7.20503265359E+00 7.33863791335E+00 7.47437302039E+00 7.61225336853E+00 7.75229337019E+00 7.89450624178E+00 8.03890406873E+00 8.18549758889E+00 8.33429615307E+00 8.48530760772E+00 8.63853818586E+00 8.79399238912E+00 8.95167287180E+00 9.11158031015E+00 9.27371327383E+00 9.43806807423E+00 9.60463863463E+00 9.77341633663E+00 9.94438983474E+00 1.01175449208E+01 1.02928643352E+01 1.04703275695E+01 1.06499107145E+01 1.08315862074E+01 1.10153226752E+01 1.12010846718E+01 1.13888325048E+01 1.15785219409E+01 1.17701040071E+01 1.19635247224E+01 1.21587248279E+01 1.23556395203E+01 1.25541981760E+01 1.27543240323E+01 1.29559339184E+01 1.31589379273E+01 1.33632390718E+01 1.35687329870E+01 1.37753075734E+01 1.39828426263E+01 1.41912095065E+01 1.44002707334E+01 1.46098796464E+01 1.48198799661E+01 1.50301054503E+01 1.52403794426E+01 1.54505144941E+01 1.56603119408E+01 1.58695614615E+01 1.60780406898E+01 1.62855147425E+01 1.64917358398E+01 1.66964428248E+01 1.68993607750E+01 1.71002005648E+01 1.72986584423E+01 1.74944156258E+01 1.76871379087E+01 1.78764752618E+01 1.80620614649E+01 1.82435137684E+01 1.84204325434E+01 1.85924009949E+01 1.87589848797E+01 1.89197322757E+01 1.90741733783E+01 1.92218203531E+01 1.93621672133E+01 1.94946898021E+01 1.96188457622E+01 1.97340746634E+01 1.98397981138E+01 1.99354200315E+01 2.00203269422E+01 2.00938884212E+01 2.01554576198E+01 2.02043718972E+01 2.02399535997E+01 2.02615109635E+01 2.02683391379E+01 2.02597214057E+01 2.02349305303E+01 2.01932302783E+01 2.01338771569E+01 2.00561223133E+01 1.99592136541E+01 1.98423981862E+01 1.97049245742E+01 1.95460459445E+01 1.93650229391E+01 1.91611270242E+01 1.89336440720E+01 1.86818782056E+01 1.84051559624E+01 1.81028307032E+01 1.77742873657E+01 1.74189474846E+01 1.70362745396E+01 1.66257795980E+01 1.61870272736E+01 1.57196419697E+01 1.52233144419E+01 1.46978086200E+01 1.41429687336E+01 1.35587266648E+01 1.29451095686E+01 1.23022476783E+01 1.16303823174E+01 1.09298740473E+01 1.02012109142E+01 9.44501678469E+00 8.66205965820E+00 7.85325993908E+00 7.01969858649E+00 6.16262505661E+00 5.28346495639E+00 4.38382733300E+00 3.46551144224E+00 2.53051293690E+00 1.58102931715E+00 6.19464496691E-01 -3.51567641392E-01 -1.32924088452E+00 -2.31051569488E+00 -3.29213976969E+00 -4.27065034999E+00 -5.24237852338E+00 -6.20345570683E+00 -7.14982259624E+00 -8.07724079673E+00 -8.98130741391E+00 -9.85747288694E+00 -1.07010623042E+01 -1.15073005142E+01 -1.22713412870E+01 -1.29883007944E+01 -1.36532956636E+01 -1.42614858312E+01 -1.48081223950E+01 -1.52886006032E+01 -1.56985180868E+01 -1.60337383218E+01 -1.62904592452E+01 -1.64652867949E+01 -1.65553130163E+01 -1.65581981257E+01 -1.64722557757E+01 -1.62965403945E+01 -1.60309351769E+01 -1.56762388866E+01 -1.52342491246E+01 -1.47078391459E+01 -1.41010246147E+01 -1.34190158814E+01 -1.26682503668E+01 -1.18563985587E+01 -1.09923357463E+01 -1.00860700812E+01 -9.14861569447E+00 -8.19179745120E+00 -7.22797137602E+00 -6.26964180600E+00 -5.32895280268E+00 -4.41702727176E+00 -3.54312237016E+00 -2.71356413558E+00 -1.93041768384E+00 -1.19340407182E+00 -5.11934310024E-01 1.00933763881E-01 6.31342957647E-01 1.06465225380E+00 1.38546060119E+00 1.57763788260E+00 1.62438243885E+00 1.50812543190E+00 1.21204363917E+00 7.06011966167E-01 8.44273970160E-02 -8.54084165146E-03 7.01847751405E-04 -2.26727922758E-04 -1.42691203564E-04 -1.59029932350E-04 -1.64990788920E-04 -1.71602971237E-04 -1.77777031988E-04 -1.83628864744E-04 -1.89155191201E-04 6 Number of nonzero Dij 1 1 9.63442442369E-01 1 2 -2.56255116839E+00 2 2 4.61504103547E+00 3 3 1.26769765322E+00 3 4 1.75040171447E+00 4 4 2.40782705081E+00 0 nqf. If not zero, Qij's inside rinner are computed using qfcoef's 1 1 0 i j (l(j)) -9.86551161683E-02 Q_int -1.65699192121E-07 -1.69046536752E-07 -1.72461502185E-07 -1.75945454450E-07 -1.79499787171E-07 -1.83125922125E-07 -1.86825309813E-07 -1.90599430034E-07 -1.94449792485E-07 -1.98377937358E-07 -2.02385435960E-07 -2.06473891340E-07 -2.10644938931E-07 -2.14900247203E-07 -2.19241518333E-07 -2.23670488882E-07 -2.28188930493E-07 -2.32798650598E-07 -2.37501493142E-07 -2.42299339320E-07 -2.47194108328E-07 -2.52187758133E-07 -2.57282286258E-07 -2.62479730574E-07 -2.67782170122E-07 -2.73191725943E-07 -2.78710561925E-07 -2.84340885667E-07 -2.90084949368E-07 -2.95945050722E-07 -3.01923533839E-07 -3.08022790184E-07 -3.14245259533E-07 -3.20593430947E-07 -3.27069843770E-07 -3.33677088644E-07 -3.40417808544E-07 -3.47294699839E-07 -3.54310513365E-07 -3.61468055530E-07 -3.68770189435E-07 -3.76219836017E-07 -3.83819975222E-07 -3.91573647194E-07 -3.99483953491E-07 -4.07554058327E-07 -4.15787189835E-07 -4.24186641363E-07 -4.32755772787E-07 -4.41498011857E-07 -4.50416855567E-07 -4.59515871555E-07 -4.68798699530E-07 -4.78269052726E-07 -4.87930719391E-07 -4.97787564299E-07 -5.07843530296E-07 -5.18102639879E-07 -5.28568996805E-07 -5.39246787730E-07 -5.50140283888E-07 -5.61253842793E-07 -5.72591909990E-07 -5.84159020827E-07 -5.95959802271E-07 -6.07998974759E-07 -6.20281354089E-07 -6.32811853340E-07 -6.45595484843E-07 -6.58637362183E-07 -6.71942702245E-07 -6.85516827303E-07 -6.99365167144E-07 -7.13493261244E-07 -7.27906760984E-07 -7.42611431907E-07 -7.57613156027E-07 -7.72917934183E-07 -7.88531888436E-07 -8.04461264518E-07 -8.20712434334E-07 -8.37291898507E-07 -8.54206288981E-07 -8.71462371670E-07 -8.89067049170E-07 -9.07027363514E-07 -9.25350498993E-07 -9.44043785027E-07 -9.63114699099E-07 -9.82570869745E-07 -1.00242007961E-06 -1.02267026854E-06 -1.04332953679E-06 -1.06440614825E-06 -1.08590853374E-06 -1.10784529439E-06 -1.13022520509E-06 -1.15305721798E-06 -1.17635046606E-06 -1.20011426680E-06 -1.22435812592E-06 -1.24909174114E-06 -1.27432500610E-06 -1.30006801430E-06 -1.32633106312E-06 -1.35312465799E-06 -1.38045951651E-06 -1.40834657284E-06 -1.43679698199E-06 -1.46582212430E-06 -1.49543361004E-06 -1.52564328398E-06 -1.55646323019E-06 -1.58790577683E-06 -1.61998350112E-06 -1.65270923434E-06 -1.68609606696E-06 -1.72015735391E-06 -1.75490671989E-06 -1.79035806482E-06 -1.82652556944E-06 -1.86342370091E-06 -1.90106721866E-06 -1.93947118029E-06 -1.97865094754E-06 -2.01862219248E-06 -2.05940090379E-06 -2.10100339310E-06 -2.14344630156E-06 -2.18674660648E-06 -2.23092162813E-06 -2.27598903666E-06 -2.32196685916E-06 -2.36887348688E-06 -2.41672768258E-06 -2.46554858807E-06 -2.51535573179E-06 -2.56616903669E-06 -2.61800882818E-06 -2.67089584224E-06 -2.72485123373E-06 -2.77989658486E-06 -2.83605391380E-06 -2.89334568350E-06 -2.95179481067E-06 -3.01142467495E-06 -3.07225912826E-06 -3.13432250433E-06 -3.19763962845E-06 -3.26223582739E-06 -3.32813693952E-06 -3.39536932515E-06 -3.46395987710E-06 -3.53393603141E-06 -3.60532577834E-06 -3.67815767356E-06 -3.75246084957E-06 -3.82826502735E-06 -3.90560052826E-06 -3.98449828615E-06 -4.06498985972E-06 -4.14710744518E-06 -4.23088388910E-06 -4.31635270155E-06 -4.40354806949E-06 -4.49250487049E-06 -4.58325868661E-06 -4.67584581869E-06 -4.77030330082E-06 -4.86666891519E-06 -4.96498120719E-06 -5.06527950081E-06 -5.16760391436E-06 -5.27199537656E-06 -5.37849564286E-06 -5.48714731216E-06 -5.59799384384E-06 -5.71107957515E-06 -5.82644973893E-06 -5.94415048170E-06 -6.06422888212E-06 -6.18673296981E-06 -6.31171174457E-06 -6.43921519596E-06 -6.56929432329E-06 -6.70200115604E-06 -6.83738877462E-06 -6.97551133164E-06 -7.11642407356E-06 -7.26018336275E-06 -7.40684670006E-06 -7.55647274780E-06 -7.70912135320E-06 -7.86485357234E-06 -8.02373169458E-06 -8.18581926743E-06 -8.35118112200E-06 -8.51988339891E-06 -8.69199357473E-06 -8.86758048897E-06 -9.04671437160E-06 -9.22946687112E-06 -9.41591108324E-06 -9.60612158009E-06 -9.80017444002E-06 -9.99814727805E-06 -1.02001192769E-05 -1.04061712185E-05 -1.06163855167E-05 -1.08308462498E-05 -1.10496391941E-05 -1.12728518589E-05 -1.15005735204E-05 -1.17328952585E-05 -1.19699099925E-05 -1.22117125183E-05 -1.24583995468E-05 -1.27100697418E-05 -1.29668237602E-05 -1.32287642917E-05 -1.34959961002E-05 -1.37686260654E-05 -1.40467632257E-05 -1.43305188218E-05 -1.46200063411E-05 -1.49153415630E-05 -1.52166426053E-05 -1.55240299716E-05 -1.58376265988E-05 -1.61575579072E-05 -1.64839518497E-05 -1.68169389638E-05 -1.71566524229E-05 -1.75032280902E-05 -1.78568045729E-05 -1.82175232773E-05 -1.85855284656E-05 -1.89609673133E-05 -1.93439899685E-05 -1.97347496113E-05 -2.01334025154E-05 -2.05401081105E-05 -2.09550290459E-05 -2.13783312558E-05 -2.18101840251E-05 -2.22507600575E-05 -2.27002355444E-05 -2.31587902352E-05 -2.36266075092E-05 -2.41038744489E-05 -2.45907819146E-05 -2.50875246210E-05 -2.55943012145E-05 -2.61113143533E-05 -2.66387707874E-05 -2.71768814422E-05 -2.77258615019E-05 -2.82859304962E-05 -2.88573123874E-05 -2.94402356605E-05 -3.00349334137E-05 -3.06416434522E-05 -3.12606083828E-05 -3.18920757112E-05 -3.25362979403E-05 -3.31935326715E-05 -3.38640427075E-05 -3.45480961570E-05 -3.52459665423E-05 -3.59579329079E-05 -3.66842799327E-05 -3.74252980430E-05 -3.81812835286E-05 -3.89525386616E-05 -3.97393718165E-05 -4.05420975937E-05 -4.13610369451E-05 -4.21965173020E-05 -4.30488727060E-05 -4.39184439425E-05 -4.48055786765E-05 -4.57106315913E-05 -4.66339645307E-05 -4.75759466426E-05 -4.85369545270E-05 -4.95173723859E-05 -5.05175921771E-05 -5.15380137701E-05 -5.25790451060E-05 -5.36411023602E-05 -5.47246101088E-05 -5.58300014972E-05 -5.69577184138E-05 -5.81082116661E-05 -5.92819411600E-05 -6.04793760839E-05 -6.17009950959E-05 -6.29472865141E-05 -6.42187485121E-05 -6.55158893172E-05 -6.68392274134E-05 -6.81892917481E-05 -6.95666219427E-05 -7.09717685086E-05 -7.24052930657E-05 -7.38677685670E-05 -7.53597795270E-05 -7.68819222544E-05 -7.84348050900E-05 -8.00190486491E-05 -8.16352860690E-05 -8.32841632612E-05 -8.49663391689E-05 -8.66824860296E-05 -8.84332896427E-05 -9.02194496431E-05 -9.20416797797E-05 -9.39007081998E-05 -9.57972777390E-05 -9.77321462174E-05 -9.97060867410E-05 -1.01719888010E-04 -1.03774354632E-04 -1.05870307444E-04 -1.08008583837E-04 -1.10190038092E-04 -1.12415541716E-04 -1.14685983794E-04 -1.17002271339E-04 -1.19365329653E-04 -1.21776102699E-04 -1.24235553471E-04 -1.26744664381E-04 -1.29304437649E-04 -1.31915895700E-04 -1.34580081573E-04 -1.37298059332E-04 -1.40070914495E-04 -1.42899754458E-04 -1.45785708942E-04 -1.48729930438E-04 -1.51733594665E-04 -1.54797901039E-04 -1.57924073147E-04 -1.61113359237E-04 -1.64367032708E-04 -1.67686392620E-04 -1.71072764209E-04 -1.74527499412E-04 -1.78051977403E-04 -1.81647605143E-04 -1.85315817935E-04 -1.89058079996E-04 -1.92875885034E-04 -1.96770756845E-04 -2.00744249915E-04 -2.04797950036E-04 -2.08933474933E-04 -2.13152474908E-04 -2.17456633494E-04 -2.21847668117E-04 -2.26327330781E-04 -2.30897408761E-04 -2.35559725308E-04 -2.40316140374E-04 -2.45168551344E-04 -2.50118893790E-04 -2.55169142235E-04 -2.60321310935E-04 -2.65577454672E-04 -2.70939669572E-04 -2.76410093925E-04 -2.81990909038E-04 -2.87684340092E-04 -2.93492657020E-04 -2.99418175406E-04 -3.05463257397E-04 -3.11630312633E-04 -3.17921799202E-04 -3.24340224605E-04 -3.30888146746E-04 -3.37568174940E-04 -3.44382970941E-04 -3.51335249990E-04 -3.58427781883E-04 -3.65663392062E-04 -3.73044962727E-04 -3.80575433969E-04 -3.88257804925E-04 -3.96095134958E-04 -4.04090544860E-04 -4.12247218073E-04 -4.20568401944E-04 -4.29057408996E-04 -4.37717618229E-04 -4.46552476445E-04 -4.55565499597E-04 -4.64760274169E-04 -4.74140458578E-04 -4.83709784611E-04 -4.93472058877E-04 -5.03431164303E-04 -5.13591061651E-04 -5.23955791060E-04 -5.34529473631E-04 -5.45316313030E-04 -5.56320597134E-04 -5.67546699696E-04 -5.78999082056E-04 -5.90682294875E-04 -6.02600979907E-04 -6.14759871809E-04 -6.27163799976E-04 -6.39817690425E-04 -6.52726567701E-04 -6.65895556836E-04 -6.79329885328E-04 -6.93034885176E-04 -7.07015994941E-04 -7.21278761854E-04 -7.35828843961E-04 -7.50672012313E-04 -7.65814153195E-04 -7.81261270398E-04 -7.97019487536E-04 -8.13095050409E-04 -8.29494329405E-04 -8.46223821960E-04 -8.63290155048E-04 -8.80700087735E-04 -8.98460513773E-04 -9.16578464245E-04 -9.35061110257E-04 -9.53915765694E-04 -9.73149890008E-04 -9.92771091078E-04 -1.01278712811E-03 -1.03320591462E-03 -1.05403552139E-03 -1.07528417964E-03 -1.09696028406E-03 -1.11907239606E-03 -1.14162924701E-03 -1.16463974155E-03 -1.18811296094E-03 -1.21205816654E-03 -1.23648480327E-03 -1.26140250320E-03 -1.28682108917E-03 -1.31275057850E-03 -1.33920118675E-03 -1.36618333154E-03 -1.39370763650E-03 -1.42178493521E-03 -1.45042627528E-03 -1.47964292244E-03 -1.50944636481E-03 -1.53984831708E-03 -1.57086072498E-03 -1.60249576961E-03 -1.63476587203E-03 -1.66768369783E-03 -1.70126216181E-03 -1.73551443274E-03 -1.77045393823E-03 -1.80609436962E-03 -1.84244968708E-03 -1.87953412464E-03 -1.91736219546E-03 -1.95594869708E-03 -1.99530871684E-03 -2.03545763734E-03 -2.07641114203E-03 -2.11818522088E-03 -2.16079617617E-03 -2.20426062833E-03 -2.24859552196E-03 -2.29381813188E-03 -2.33994606929E-03 -2.38699728811E-03 -2.43499009133E-03 -2.48394313752E-03 -2.53387544745E-03 -2.58480641079E-03 -2.63675579298E-03 -2.68974374211E-03 -2.74379079604E-03 -2.79891788953E-03 -2.85514636158E-03 -2.91249796277E-03 -2.97099486285E-03 -3.03065965835E-03 -3.09151538036E-03 -3.15358550242E-03 -3.21689394855E-03 -3.28146510137E-03 -3.34732381036E-03 -3.41449540029E-03 -3.48300567970E-03 -3.55288094957E-03 -3.62414801208E-03 -3.69683417955E-03 -3.77096728345E-03 -3.84657568359E-03 -3.92368827740E-03 -4.00233450940E-03 -4.08254438075E-03 -4.16434845895E-03 -4.24777788769E-03 -4.33286439681E-03 -4.41964031244E-03 -4.50813856719E-03 -4.59839271056E-03 -4.69043691945E-03 -4.78430600881E-03 -4.88003544239E-03 -4.97766134368E-03 -5.07722050695E-03 -5.17875040843E-03 -5.28228921760E-03 -5.38787580865E-03 -5.49554977203E-03 -5.60535142615E-03 -5.71732182922E-03 -5.83150279114E-03 -5.94793688563E-03 -6.06666746236E-03 -6.18773865928E-03 -6.31119541502E-03 -6.43708348144E-03 -6.56544943624E-03 -6.69634069570E-03 -6.82980552754E-03 -6.96589306385E-03 -7.10465331408E-03 -7.24613717822E-03 -7.39039645998E-03 -7.53748388001E-03 -7.68745308932E-03 -7.84035868268E-03 -7.99625621204E-03 -8.15520220011E-03 -8.31725415390E-03 -8.48247057831E-03 -8.65091098979E-03 -8.82263592997E-03 -8.99770697931E-03 -9.17618677077E-03 -9.35813900344E-03 -9.54362845617E-03 -9.73272100115E-03 -9.92548361745E-03 -1.01219844045E-02 -1.03222925954E-02 -1.05264785706E-02 -1.07346138704E-02 -1.09467712087E-02 -1.11630244858E-02 -1.13834488009E-02 -1.16081204650E-02 -1.18371170132E-02 -1.20705172169E-02 -1.23084010957E-02 -1.25508499295E-02 -1.27979462693E-02 -1.30497739486E-02 -1.33064180945E-02 -1.35679651372E-02 -1.38345028212E-02 -1.41061202138E-02 -1.43829077149E-02 -1.46649570653E-02 -1.49523613551E-02 -1.52452150308E-02 -1.55436139027E-02 -1.58476551512E-02 -1.61574373319E-02 -1.64730603811E-02 -1.67946256197E-02 -1.71222357567E-02 -1.74559948913E-02 -1.77960085148E-02 -1.81423835109E-02 -1.84952281558E-02 -1.88546521160E-02 -1.92207664461E-02 -1.95936835848E-02 -1.99735173498E-02 -2.03603829314E-02 -2.07543968844E-02 -2.11556771193E-02 -2.15643428909E-02 -2.19805147861E-02 -2.24043147094E-02 -2.28358658672E-02 -2.32752927498E-02 -2.37227211116E-02 -2.41782779488E-02 -2.46420914760E-02 -2.51142910993E-02 -2.55950073875E-02 -2.60843720415E-02 -2.65825178600E-02 -2.70895787032E-02 -2.76056894533E-02 -2.81309859725E-02 -2.86656050577E-02 -2.92096843915E-02 -2.97633624908E-02 -3.03267786511E-02 -3.09000728877E-02 -3.14833858728E-02 -3.20768588688E-02 -3.26806336574E-02 -3.32948524646E-02 -3.39196578811E-02 -3.45551927783E-02 -3.52016002194E-02 -3.58590233652E-02 -3.65276053756E-02 -3.72074893047E-02 -3.78988179914E-02 -3.86017339431E-02 -3.93163792146E-02 -4.00428952799E-02 -4.07814228983E-02 -4.15321019731E-02 -4.22950714043E-02 -4.30704689336E-02 -4.38584309823E-02 -4.46590924814E-02 -4.54725866945E-02 -4.62990450318E-02 -4.71385968563E-02 -4.79913692809E-02 -4.88574869576E-02 -4.97370718564E-02 -5.06302430355E-02 -5.15371164016E-02 -5.24578044602E-02 -5.33924160558E-02 -5.43410561012E-02 -5.53038252965E-02 -5.62808198365E-02 -5.72721311072E-02 -5.82778453700E-02 -5.92980434342E-02 -6.03328003176E-02 -6.13821848941E-02 -6.24462595285E-02 -6.35250796984E-02 -6.46186936028E-02 -6.57271417565E-02 -6.68504565717E-02 -6.79886619241E-02 -6.91417727058E-02 -7.03097943629E-02 -7.14927224186E-02 -7.26905419811E-02 -7.39032272367E-02 -7.51307409270E-02 -7.63730338109E-02 -7.76300441108E-02 -7.89016969439E-02 -8.01879037362E-02 -8.14885616220E-02 -8.28035528270E-02 -8.41327440359E-02 -8.54759857439E-02 -8.68331115925E-02 -8.82039376909E-02 -8.95882619203E-02 -9.09858632252E-02 -9.23965008884E-02 -9.38199137926E-02 -9.52558196675E-02 -9.67039143243E-02 -9.81638708765E-02 -9.96353389491E-02 -1.01117943876E-01 -1.02611285888E-01 -1.04114939289E-01 -1.05628451625E-01 -1.07151342846E-01 -1.08683104460E-01 -1.10223198684E-01 -1.11771057590E-01 -1.13326082251E-01 -1.14887641882E-01 -1.16455072991E-01 -1.18027678529E-01 -1.19604727043E-01 -1.21185451846E-01 -1.22769050186E-01 -1.24354682446E-01 -1.25941471340E-01 -1.27528501146E-01 -1.29114816955E-01 -1.30699423943E-01 -1.32281286684E-01 -1.33859328483E-01 -1.35432430763E-01 -1.36999432484E-01 -1.38559129614E-01 -1.40110274651E-01 -1.41651576207E-01 -1.43181698650E-01 -1.44699261818E-01 -1.46202840807E-01 -1.47690965843E-01 -1.49162122239E-01 -1.50614750444E-01 -1.52047246201E-01 -1.53457960810E-01 -1.54845201505E-01 -1.56207231960E-01 -1.57542272923E-01 -1.58848502997E-01 -1.60124059560E-01 -1.61367039857E-01 -1.62575502240E-01 -1.63747467606E-01 -1.64880920998E-01 -1.65973813416E-01 -1.67024063821E-01 -1.68029561360E-01 -1.68988167803E-01 -1.69897720224E-01 -1.70756033905E-01 -1.71560905506E-01 -1.72310116482E-01 -1.73001436768E-01 -1.73632628738E-01 -1.74201451450E-01 -1.74705665168E-01 -1.75143036192E-01 -1.75511341977E-01 -1.75808376561E-01 -1.76031956300E-01 -1.76179925914E-01 -1.76250164849E-01 -1.76240593938E-01 -1.76149182387E-01 -1.75973955061E-01 -1.75713000070E-01 -1.75364476651E-01 -1.74926623339E-01 -1.74397766409E-01 -1.73776328576E-01 -1.73060837940E-01 -1.72249937160E-01 -1.71342392820E-01 -1.70337104976E-01 -1.69233116851E-01 -1.68029624640E-01 -1.66725987394E-01 -1.65321736948E-01 -1.63816587833E-01 -1.62210447142E-01 -1.60503424290E-01 -1.58695840604E-01 -1.56788238702E-01 -1.54781391580E-01 -1.52676311338E-01 -1.50474257484E-01 -1.48176744734E-01 -1.45785550214E-01 -1.43302720004E-01 -1.40730574913E-01 -1.38071715409E-01 -1.35329025607E-01 -1.32505676207E-01 -1.29605126314E-01 -1.26631124006E-01 -1.23587705576E-01 -1.20479193352E-01 -1.17310191975E-01 -1.14085583069E-01 -1.10810518197E-01 -1.07490410024E-01 -1.04130921607E-01 -1.00737953739E-01 -9.73176302901E-02 -9.38762814885E-02 -9.04204251046E-02 -8.69567455142E-02 -8.34920706281E-02 -8.00333466974E-02 -7.65876110196E-02 -7.31619625942E-02 -6.97635307957E-02 -6.63994421591E-02 -6.30767853957E-02 -5.98025747865E-02 -5.65837121267E-02 -5.34269474248E-02 -5.03388385893E-02 -4.73257103670E-02 -4.43936128265E-02 -4.15482797106E-02 -3.87950870124E-02 -3.61390121555E-02 -3.35845941889E-02 -3.11358954282E-02 -2.87964649986E-02 -2.65693047550E-02 -2.44568380643E-02 -2.24608819519E-02 -2.05826231125E-02 -1.88225982906E-02 -1.71806795237E-02 -1.56560647332E-02 -1.42472741217E-02 -1.29521528105E-02 -1.17678801143E-02 -1.06909858039E-02 -9.71737365929E-03 -8.84235255054E-03 -8.06067522071E-03 -7.36658486701E-03 -6.75386953590E-03 -6.21592426016E-03 -5.74582077295E-03 -5.33638453750E-03 -4.98027873136E-03 -4.67009472303E-03 -4.39844847716E-03 -4.15808222410E-03 -3.94197063114E-03 -3.74343061800E-03 -3.55623386850E-03 -3.37472100499E-03 -3.19391631242E-03 -3.00964182466E-03 -2.81862951676E-03 -2.61863028255E-03 -2.40851831524E-03 -2.18838944822E-03 -1.95965195161E-03 -1.72510821354E-03 -1.48902566160E-03 -1.25719519505E-03 -1.03697529891E-03 -8.35864510972E-04 -6.56481279729E-04 -4.99746720517E-04 -3.66127346681E-04 -2.55587631260E-04 -1.67544638900E-04 -1.00825193312E-04 -5.36260597913E-05 -2.34776395287E-05 -7.21169352417E-06 -9.33639799372E-07 2.77020844649E-17 1.82411616682E-17 -4.95435992459E-18 -2.12780709285E-17 1.51982009691E-17 2.68676241510E-17 2.25785372043E-17 -6.35576690336E-18 2.46187402522E-17 -2.78347214560E-18 -1.85616374038E-17 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1 2 0 i j (l(j)) 4.86462768930E-01 Q_int 8.11720474539E-07 8.28118310407E-07 8.44847404311E-07 8.61914448097E-07 8.79326268798E-07 8.97089831359E-07 9.15212241426E-07 9.33700748190E-07 9.52562747283E-07 9.71805783739E-07 9.91437555012E-07 1.01146591405E-06 1.03189887245E-06 1.05274460365E-06 1.07401144619E-06 1.09570790708E-06 1.11784266516E-06 1.14042457460E-06 1.16346266846E-06 1.18696616225E-06 1.21094445765E-06 1.23540714628E-06 1.26036401350E-06 1.28582504237E-06 1.31180041760E-06 1.33830052966E-06 1.36533597892E-06 1.39291757987E-06 1.42105636550E-06 1.44976359165E-06 1.47905074155E-06 1.50892953042E-06 1.53941191013E-06 1.57051007398E-06 1.60223646162E-06 1.63460376397E-06 1.66762492833E-06 1.70131316357E-06 1.73568194536E-06 1.77074502162E-06 1.80651641799E-06 1.84301044344E-06 1.88024169601E-06 1.91822506863E-06 1.95697575508E-06 1.99650925609E-06 2.03684138550E-06 2.07798827662E-06 2.11996638869E-06 2.16279251341E-06 2.20648378172E-06 2.25105767063E-06 2.29653201018E-06 2.34292499061E-06 2.39025516964E-06 2.43854147986E-06 2.48780323633E-06 2.53806014428E-06 2.58933230703E-06 2.64164023400E-06 2.69500484893E-06 2.74944749823E-06 2.80498995956E-06 2.86165445048E-06 2.91946363740E-06 2.97844064460E-06 3.03860906351E-06 3.09999296211E-06 3.16261689460E-06 3.22650591120E-06 3.29168556819E-06 3.35818193807E-06 3.42602162008E-06 3.49523175077E-06 3.56584001488E-06 3.63787465643E-06 3.71136448997E-06 3.78633891217E-06 3.86282791352E-06 3.94086209035E-06 4.02047265710E-06 4.10169145873E-06 4.18455098355E-06 4.26908437612E-06 4.35532545060E-06 4.44330870420E-06 4.53306933102E-06 4.62464323613E-06 4.71806704991E-06 4.81337814270E-06 4.91061463977E-06 5.00981543658E-06 5.11102021427E-06 5.21426945563E-06 5.31960446122E-06 5.42706736589E-06 5.53670115570E-06 5.64854968505E-06 5.76265769423E-06 5.87907082734E-06 5.99783565054E-06 6.11899967065E-06 6.24261135421E-06 6.36872014679E-06 6.49737649282E-06 6.62863185577E-06 6.76253873870E-06 6.89915070528E-06 7.03852240123E-06 7.18070957614E-06 7.32576910582E-06 7.47375901499E-06 7.62473850054E-06 7.77876795517E-06 7.93590899158E-06 8.09622446710E-06 8.25977850880E-06 8.42663653921E-06 8.59686530242E-06 8.77053289081E-06 8.94770877228E-06 9.12846381804E-06 9.31287033093E-06 9.50100207439E-06 9.69293430192E-06 9.88874378720E-06 1.00885088548E-05 1.02923094114E-05 1.05002269781E-05 1.07123447225E-05 1.09287474924E-05 1.11495218496E-05 1.13747561043E-05 1.16045403509E-05 1.18389665035E-05 1.20781283331E-05 1.23221215049E-05 1.25710436166E-05 1.28249942372E-05 1.30840749474E-05 1.33483893796E-05 1.36180432598E-05 1.38931444497E-05 1.41738029897E-05 1.44601311432E-05 1.47522434413E-05 1.50502567287E-05 1.53542902105E-05 1.56644654997E-05 1.59809066659E-05 1.63037402849E-05 1.66330954894E-05 1.69691040208E-05 1.73119002815E-05 1.76616213889E-05 1.80184072302E-05 1.83824005184E-05 1.87537468494E-05 1.91325947598E-05 1.95190957871E-05 1.99134045296E-05 2.03156787086E-05 2.07260792313E-05 2.11447702554E-05 2.15719192543E-05 2.20076970846E-05 2.24522780541E-05 2.29058399916E-05 2.33685643180E-05 2.38406361188E-05 2.43222442185E-05 2.48135812555E-05 2.53148437595E-05 2.58262322302E-05 2.63479512171E-05 2.68802094017E-05 2.74232196808E-05 2.79771992514E-05 2.85423696981E-05 2.91189570812E-05 2.97071920274E-05 3.03073098217E-05 3.09195505020E-05 3.15441589547E-05 3.21813850127E-05 3.28314835554E-05 3.34947146105E-05 3.41713434582E-05 3.48616407369E-05 3.55658825519E-05 3.62843505853E-05 3.70173322092E-05 3.77651206001E-05 3.85280148564E-05 3.93063201180E-05 4.01003476882E-05 4.09104151583E-05 4.17368465344E-05 4.25799723674E-05 4.34401298845E-05 4.43176631246E-05 4.52129230756E-05 4.61262678150E-05 4.70580626525E-05 4.80086802769E-05 4.89785009042E-05 4.99679124306E-05 5.09773105865E-05 5.20070990957E-05 5.30576898364E-05 5.41295030056E-05 5.52229672877E-05 5.63385200254E-05 5.74766073948E-05 5.86376845836E-05 5.98222159734E-05 6.10306753249E-05 6.22635459678E-05 6.35213209935E-05 6.48045034527E-05 6.61136065563E-05 6.74491538804E-05 6.88116795760E-05 7.02017285822E-05 7.16198568440E-05 7.30666315349E-05 7.45426312834E-05 7.60484464041E-05 7.75846791341E-05 7.91519438733E-05 8.07508674304E-05 8.23820892729E-05 8.40462617834E-05 8.57440505197E-05 8.74761344812E-05 8.92432063802E-05 9.10459729188E-05 9.28851550711E-05 9.47614883718E-05 9.66757232097E-05 9.86286251279E-05 1.00620975130E-04 1.02653569991E-04 1.04727222577E-04 1.06842762170E-04 1.09001034799E-04 1.11202903577E-04 1.13449249048E-04 1.15740969537E-04 1.18078981510E-04 1.20464219939E-04 1.22897638679E-04 1.25380210845E-04 1.27912929200E-04 1.30496806559E-04 1.33132876184E-04 1.35822192205E-04 1.38565830035E-04 1.41364886804E-04 1.44220481795E-04 1.47133756892E-04 1.50105877034E-04 1.53138030685E-04 1.56231430303E-04 1.59387312830E-04 1.62606940180E-04 1.65891599750E-04 1.69242604926E-04 1.72661295616E-04 1.76149038778E-04 1.79707228972E-04 1.83337288910E-04 1.87040670032E-04 1.90818853078E-04 1.94673348685E-04 1.98605697988E-04 2.02617473235E-04 2.06710278414E-04 2.10885749896E-04 2.15145557086E-04 2.19491403090E-04 2.23925025395E-04 2.28448196563E-04 2.33062724939E-04 2.37770455369E-04 2.42573269942E-04 2.47473088737E-04 2.52471870593E-04 2.57571613884E-04 2.62774357325E-04 2.68082180779E-04 2.73497206091E-04 2.79021597930E-04 2.84657564659E-04 2.90407359210E-04 2.96273279986E-04 3.02257671777E-04 3.08362926695E-04 3.14591485130E-04 3.20945836721E-04 3.27428521349E-04 3.34042130150E-04 3.40789306552E-04 3.47672747323E-04 3.54695203650E-04 3.61859482236E-04 3.69168446415E-04 3.76625017300E-04 3.84232174942E-04 3.91992959518E-04 3.99910472547E-04 4.07987878121E-04 4.16228404170E-04 4.24635343743E-04 4.33212056327E-04 4.41961969179E-04 4.50888578694E-04 4.59995451800E-04 4.69286227374E-04 4.78764617693E-04 4.88434409915E-04 4.98299467584E-04 5.08363732168E-04 5.18631224631E-04 5.29106047030E-04 5.39792384151E-04 5.50694505173E-04 5.61816765366E-04 5.73163607826E-04 5.84739565242E-04 5.96549261699E-04 6.08597414517E-04 6.20888836128E-04 6.33428435989E-04 6.46221222536E-04 6.59272305174E-04 6.72586896306E-04 6.86170313409E-04 7.00027981147E-04 7.14165433524E-04 7.28588316083E-04 7.43302388151E-04 7.58313525129E-04 7.73627720817E-04 7.89251089805E-04 8.05189869891E-04 8.21450424566E-04 8.38039245534E-04 8.54962955289E-04 8.72228309748E-04 8.89842200924E-04 9.07811659665E-04 9.26143858441E-04 9.44846114189E-04 9.63925891212E-04 9.83390804141E-04 1.00324862095E-03 1.02350726603E-03 1.04417482335E-03 1.06525953962E-03 1.08676982760E-03 1.10871426939E-03 1.13110161988E-03 1.15394081015E-03 1.17724095104E-03 1.20101133678E-03 1.22526144861E-03 1.25000095857E-03 1.27523973330E-03 1.30098783795E-03 1.32725554017E-03 1.35405331413E-03 1.38139184471E-03 1.40928203166E-03 1.43773499395E-03 1.46676207412E-03 1.49637484280E-03 1.52658510322E-03 1.55740489591E-03 1.58884650341E-03 1.62092245514E-03 1.65364553232E-03 1.68702877301E-03 1.72108547723E-03 1.75582921220E-03 1.79127381770E-03 1.82743341148E-03 1.86432239483E-03 1.90195545822E-03 1.94034758711E-03 1.97951406780E-03 2.01947049345E-03 2.06023277017E-03 2.10181712331E-03 2.14424010378E-03 2.18751859454E-03 2.23166981726E-03 2.27671133900E-03 2.32266107913E-03 2.36953731633E-03 2.41735869573E-03 2.46614423623E-03 2.51591333788E-03 2.56668578950E-03 2.61848177641E-03 2.67132188825E-03 2.72522712708E-03 2.78021891551E-03 2.83631910508E-03 2.89354998475E-03 2.95193428959E-03 3.01149520960E-03 3.07225639874E-03 3.13424198412E-03 3.19747657534E-03 3.26198527409E-03 3.32779368383E-03 3.39492791973E-03 3.46341461881E-03 3.53328095020E-03 3.60455462568E-03 3.67726391038E-03 3.75143763369E-03 3.82710520040E-03 3.90429660202E-03 3.98304242834E-03 4.06337387922E-03 4.14532277659E-03 4.22892157665E-03 4.31420338240E-03 4.40120195626E-03 4.48995173310E-03 4.58048783337E-03 4.67284607657E-03 4.76706299493E-03 4.86317584739E-03 4.96122263380E-03 5.06124210941E-03 5.16327379965E-03 5.26735801515E-03 5.37353586706E-03 5.48184928269E-03 5.59234102137E-03 5.70505469069E-03 5.82003476298E-03 5.93732659214E-03 6.05697643073E-03 6.17903144744E-03 6.30353974485E-03 6.43055037752E-03 6.56011337042E-03 6.69227973770E-03 6.82710150179E-03 6.96463171287E-03 7.10492446872E-03 7.24803493485E-03 7.39401936508E-03 7.54293512247E-03 7.69484070061E-03 7.84979574530E-03 8.00786107668E-03 8.16909871162E-03 8.33357188671E-03 8.50134508145E-03 8.67248404205E-03 8.84705580547E-03 9.02512872406E-03 9.20677249049E-03 9.39205816324E-03 9.58105819243E-03 9.77384644618E-03 9.97049823742E-03 1.01710903511E-02 1.03757010720E-02 1.05844102129E-02 1.07972991432E-02 1.10144508184E-02 1.12359498093E-02 1.14618823326E-02 1.16923362817E-02 1.19274012573E-02 1.21671686000E-02 1.24117314217E-02 1.26611846391E-02 1.29156250068E-02 1.31751511511E-02 1.34398636048E-02 1.37098648417E-02 1.39852593127E-02 1.42661534816E-02 1.45526558621E-02 1.48448770550E-02 1.51429297859E-02 1.54469289444E-02 1.57569916222E-02 1.60732371538E-02 1.63957871560E-02 1.67247655696E-02 1.70602987001E-02 1.74025152607E-02 1.77515464148E-02 1.81075258190E-02 1.84705896678E-02 1.88408767382E-02 1.92185284347E-02 1.96036888354E-02 1.99965047391E-02 2.03971257119E-02 2.08057041355E-02 2.12223952558E-02 2.16473572319E-02 2.20807511863E-02 2.25227412550E-02 2.29734946392E-02 2.34331816565E-02 2.39019757938E-02 2.43800537603E-02 2.48675955411E-02 2.53647844518E-02 2.58718071932E-02 2.63888539071E-02 2.69161182325E-02 2.74537973623E-02 2.80020921011E-02 2.85612069227E-02 2.91313500289E-02 2.97127334090E-02 3.03055728989E-02 3.09100882419E-02 3.15265031491E-02 3.21550453609E-02 3.27959467086E-02 3.34494431767E-02 3.41157749659E-02 3.47951865557E-02 3.54879267681E-02 3.61942488318E-02 3.69144104459E-02 3.76486738451E-02 3.83973058639E-02 3.91605780022E-02 3.99387664905E-02 4.07321523552E-02 4.15410214846E-02 4.23656646942E-02 4.32063777931E-02 4.40634616491E-02 4.49372222552E-02 4.58279707946E-02 4.67360237066E-02 4.76617027519E-02 4.86053350772E-02 4.95672532805E-02 5.05477954749E-02 5.15473053523E-02 5.25661322469E-02 5.36046311978E-02 5.46631630104E-02 5.57420943177E-02 5.68417976402E-02 5.79626514452E-02 5.91050402045E-02 6.02693544512E-02 6.14559908349E-02 6.26653521760E-02 6.38978475173E-02 6.51538921752E-02 6.64339077882E-02 6.77383223635E-02 6.90675703216E-02 7.04220925385E-02 7.18023363857E-02 7.32087557667E-02 7.46418111520E-02 7.61019696099E-02 7.75897048346E-02 7.91054971707E-02 8.06498336347E-02 8.22232079313E-02 8.38261204673E-02 8.54590783597E-02 8.71225954401E-02 8.88171922541E-02 9.05433960552E-02 9.23017407940E-02 9.40927671009E-02 9.59170222635E-02 9.77750601974E-02 9.96674414103E-02 1.01594732959E-01 1.03557508400E-01 1.05556347731E-01 1.07591837324E-01 1.09664569853E-01 1.11775144210E-01 1.13924165411E-01 1.16112244493E-01 1.18339998406E-01 1.20608049883E-01 1.22917027311E-01 1.25267564581E-01 1.27660300930E-01 1.30095880772E-01 1.32574953509E-01 1.35098173336E-01 1.37666199027E-01 1.40279693705E-01 1.42939324598E-01 1.45645762780E-01 1.48399682891E-01 1.51201762842E-01 1.54052683501E-01 1.56953128357E-01 1.59903783171E-01 1.62905335594E-01 1.65958474778E-01 1.69063890949E-01 1.72222274972E-01 1.75434317877E-01 1.78700710373E-01 1.82022142323E-01 1.85399302204E-01 1.88832876531E-01 1.92323549253E-01 1.95872001121E-01 1.99478909023E-01 2.03144945288E-01 2.06870776956E-01 2.10657065012E-01 2.14504463588E-01 2.18413619122E-01 2.22385169486E-01 2.26419743072E-01 2.30517957833E-01 2.34680420291E-01 2.38907724493E-01 2.43200450932E-01 2.47559165412E-01 2.51984417875E-01 2.56476741178E-01 2.61036649815E-01 2.65664638594E-01 2.70361181263E-01 2.75126729073E-01 2.79961709301E-01 2.84866523703E-01 2.89841546918E-01 2.94887124808E-01 3.00003572746E-01 3.05191173832E-01 3.10450177055E-01 3.15780795388E-01 3.21183203819E-01 3.26657537313E-01 3.32203888713E-01 3.37822306568E-01 3.43512792894E-01 3.49275300864E-01 3.55109732430E-01 3.61015935868E-01 3.66993703261E-01 3.73042767896E-01 3.79162801602E-01 3.85353412006E-01 3.91614139715E-01 3.97944455435E-01 4.04343757005E-01 4.10811366363E-01 4.17346526446E-01 4.23948398008E-01 4.30616056377E-01 4.37348488137E-01 4.44144587747E-01 4.51003154094E-01 4.57922886977E-01 4.64902383539E-01 4.71940134634E-01 4.79034521144E-01 4.86183810239E-01 4.93386151594E-01 5.00639573561E-01 5.07941979305E-01 5.15291142904E-01 5.22684705424E-01 5.30120170972E-01 5.37594902740E-01 5.45106119032E-01 5.52650889310E-01 5.60226130235E-01 5.67828601735E-01 5.75454903111E-01 5.83101469172E-01 5.90764566434E-01 5.98440289379E-01 6.06124556802E-01 6.13813108243E-01 6.21501500539E-01 6.29185104491E-01 6.36859101689E-01 6.44518481481E-01 6.52158038141E-01 6.59772368227E-01 6.67355868163E-01 6.74902732073E-01 6.82406949879E-01 6.89862305693E-01 6.97262376531E-01 7.04600531372E-01 7.11869930596E-01 7.19063525825E-01 7.26174060194E-01 7.33194069100E-01 7.40115881440E-01 7.46931621388E-01 7.53633210743E-01 7.60212371870E-01 7.66660631300E-01 7.72969323985E-01 7.79129598296E-01 7.85132421750E-01 7.90968587557E-01 7.96628721979E-01 8.02103292582E-01 8.07382617395E-01 8.12456875020E-01 8.17316115748E-01 8.21950273701E-01 8.26349180049E-01 8.30502577337E-01 8.34400134958E-01 8.38031465813E-01 8.41386144171E-01 8.44453724789E-01 8.47223763290E-01 8.49685837842E-01 8.51829572156E-01 8.53644659811E-01 8.55120889928E-01 8.56248174189E-01 8.57016575223E-01 8.57416336320E-01 8.57437912500E-01 8.57072002885E-01 8.56309584367E-01 8.55141946526E-01 8.53560727754E-01 8.51557952531E-01 8.49126069788E-01 8.46257992265E-01 8.42947136796E-01 8.39187465400E-01 8.34973527061E-01 8.30300500076E-01 8.25164234823E-01 8.19561296774E-01 8.13489009592E-01 8.06945498110E-01 7.99929730991E-01 7.92441562821E-01 7.84481775422E-01 7.76052118098E-01 7.67155346553E-01 7.57795260179E-01 7.47976737414E-01 7.37705768833E-01 7.26989487649E-01 7.15836197258E-01 7.04255395478E-01 6.92257795101E-01 6.79855340380E-01 6.67061219071E-01 6.53889869627E-01 6.40356983175E-01 6.26479499875E-01 6.12275599283E-01 5.97764684369E-01 5.82967358811E-01 5.67905397258E-01 5.52601708238E-01 5.37080289441E-01 5.21366175144E-01 5.05485375561E-01 4.89464807992E-01 4.73332219652E-01 4.57116102158E-01 4.40845597707E-01 4.24550397041E-01 4.08260629389E-01 3.92006744656E-01 3.75819388228E-01 3.59729268829E-01 3.43767020021E-01 3.27963055981E-01 3.12347422345E-01 2.96949642994E-01 2.81798563768E-01 2.66922194220E-01 2.52347548603E-01 2.38100487412E-01 2.24205560878E-01 2.10685855918E-01 1.97562848108E-01 1.84856260329E-01 1.72583929771E-01 1.60761685031E-01 1.49403235040E-01 1.38520071574E-01 1.28121387033E-01 1.18214009163E-01 1.08802354272E-01 9.98884004039E-02 9.14716817671E-02 8.35493055508E-02 7.61159920443E-02 6.91641387272E-02 6.26839087229E-02 5.66633436925E-02 5.10885009079E-02 4.59436138690E-02 4.12112754324E-02 3.68726420019E-02 3.29076568916E-02 2.92952905216E-02 2.60137946491E-02 2.30409673759E-02 2.03544252207E-02 1.79318780991E-02 1.57514026342E-02 1.37917088232E-02 1.20323947253E-02 1.04541835189E-02 9.03913701103E-03 7.77083947113E-03 6.63454552247E-03 5.61728575598E-03 4.70792374459E-03 3.89715823950E-03 3.17746452903E-03 2.54296924588E-03 1.98925332754E-03 1.51307837906E-03 1.11203236816E-03 7.84091413946E-04 5.26164659971E-04 3.30924797834E-04 1.89710822914E-04 9.36374844204E-05 3.37903654697E-05 1.45783877276E-06 -1.15980361028E-05 -1.28297771906E-05 -8.55022772025E-06 -3.53438321313E-06 -5.76236643590E-07 -4.62718267221E-18 8.78498383576E-18 -1.21234788267E-17 2.28539449571E-17 8.68225779244E-18 -3.98859038229E-17 -1.06425921382E-16 3.56870056490E-17 -2.70137057763E-17 2.40148579795E-17 6.10499199734E-18 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1 3 1 i j (l(j)) 0.00000000000E+00 Q_int -7.21501091422E-11 -7.43474068007E-11 -7.66116221204E-11 -7.89447930468E-11 -8.13490195899E-11 -8.38264657147E-11 -8.63793612884E-11 -8.90100040880E-11 -9.17207618679E-11 -9.45140744915E-11 -9.73924561271E-11 -1.00358497511E-10 -1.03414868278E-10 -1.06564319366E-10 -1.09809685493E-10 -1.13153887704E-10 -1.16599936004E-10 -1.20150932069E-10 -1.23810072030E-10 -1.27580649359E-10 -1.31466057826E-10 -1.35469794559E-10 -1.39595463188E-10 -1.43846777089E-10 -1.48227562730E-10 -1.52741763108E-10 -1.57393441306E-10 -1.62186784144E-10 -1.67126105949E-10 -1.72215852440E-10 -1.77460604729E-10 -1.82865083441E-10 -1.88434152966E-10 -1.94172825838E-10 -2.00086267244E-10 -2.06179799675E-10 -2.12458907715E-10 -2.18929242979E-10 -2.25596629197E-10 -2.32467067460E-10 -2.39546741620E-10 -2.46842023852E-10 -2.54359480394E-10 -2.62105877457E-10 -2.70088187310E-10 -2.78313594562E-10 -2.86789502624E-10 -2.95523540375E-10 -3.04523569027E-10 -3.13797689200E-10 -3.23354248218E-10 -3.33201847614E-10 -3.43349350879E-10 -3.53805891437E-10 -3.64580880863E-10 -3.75684017361E-10 -3.87125294484E-10 -3.98915010137E-10 -4.11063775841E-10 -4.23582526286E-10 -4.36482529171E-10 -4.49775395347E-10 -4.63473089269E-10 -4.77587939761E-10 -4.92132651117E-10 -5.07120314531E-10 -5.22564419884E-10 -5.38478867885E-10 -5.54877982579E-10 -5.71776524245E-10 -5.89189702675E-10 -6.07133190871E-10 -6.25623139145E-10 -6.44676189658E-10 -6.64309491400E-10 -6.84540715625E-10 -7.05388071752E-10 -7.26870323762E-10 -7.49006807081E-10 -7.71817445983E-10 -7.95322771527E-10 -8.19543940033E-10 -8.44502752125E-10 -8.70221672354E-10 -8.96723849415E-10 -9.24033136983E-10 -9.52174115184E-10 -9.81172112718E-10 -1.01105322966E-09 -1.04184436093E-09 -1.07357322055E-09 -1.10626836652E-09 -1.13995922659E-09 -1.17467612470E-09 -1.21045030827E-09 -1.24731397638E-09 -1.28530030869E-09 -1.32444349532E-09 -1.36477876765E-09 -1.40634243000E-09 -1.44917189231E-09 -1.49330570385E-09 -1.53878358783E-09 -1.58564647726E-09 -1.63393655170E-09 -1.68369727529E-09 -1.73497343583E-09 -1.78781118511E-09 -1.84225808043E-09 -1.89836312745E-09 -1.95617682423E-09 -2.01575120673E-09 -2.07713989566E-09 -2.14039814466E-09 -2.20558289014E-09 -2.27275280243E-09 -2.34196833864E-09 -2.41329179708E-09 -2.48678737330E-09 -2.56252121787E-09 -2.64056149594E-09 -2.72097844861E-09 -2.80384445609E-09 -2.88923410290E-09 -2.97722424497E-09 -3.06789407884E-09 -3.16132521292E-09 -3.25760174093E-09 -3.35681031763E-09 -3.45904023678E-09 -3.56438351152E-09 -3.67293495718E-09 -3.78479227663E-09 -3.90005614822E-09 -4.01883031636E-09 -4.14122168494E-09 -4.26734041352E-09 -4.39730001650E-09 -4.53121746526E-09 -4.66921329346E-09 -4.81141170554E-09 -4.95794068847E-09 -5.10893212697E-09 -5.26452192221E-09 -5.42485011412E-09 -5.59006100743E-09 -5.76030330158E-09 -5.93573022451E-09 -6.11649967059E-09 -6.30277434275E-09 -6.49472189890E-09 -6.69251510283E-09 -6.89633197971E-09 -7.10635597630E-09 -7.32277612610E-09 -7.54578721944E-09 -7.77558997885E-09 -8.01239123965E-09 -8.25640413618E-09 -8.50784829358E-09 -8.76695002548E-09 -9.03394253768E-09 -9.30906613806E-09 -9.59256845285E-09 -9.88470464949E-09 -1.01857376663E-08 -1.04959384492E-08 -1.08155861954E-08 -1.11449686049E-08 -1.14843821393E-08 -1.18341322885E-08 -1.21945338459E-08 -1.25659111916E-08 -1.29485985845E-08 -1.33429404628E-08 -1.37492917542E-08 -1.41680181955E-08 -1.45994966616E-08 -1.50441155045E-08 -1.55022749034E-08 -1.59743872241E-08 -1.64608773908E-08 -1.69621832683E-08 -1.74787560559E-08 -1.80110606938E-08 -1.85595762813E-08 -1.91247965081E-08 -1.97072300987E-08 -2.03074012701E-08 -2.09258502038E-08 -2.15631335317E-08 -2.22198248372E-08 -2.28965151717E-08 -2.35938135859E-08 -2.43123476787E-08 -2.50527641615E-08 -2.58157294405E-08 -2.66019302162E-08 -2.74120741018E-08 -2.82468902599E-08 -2.91071300585E-08 -2.99935677474E-08 -3.09070011554E-08 -3.18482524076E-08 -3.28181686659E-08 -3.38176228910E-08 -3.48475146285E-08 -3.59087708181E-08 -3.70023466280E-08 -3.81292263145E-08 -3.92904241078E-08 -4.04869851247E-08 -4.17199863095E-08 -4.29905374027E-08 -4.42997819402E-08 -4.56488982822E-08 -4.70391006737E-08 -4.84716403374E-08 -4.99478065996E-08 -5.14689280506E-08 -5.30363737404E-08 -5.46515544109E-08 -5.63159237651E-08 -5.80309797759E-08 -5.97982660337E-08 -6.16193731359E-08 -6.34959401181E-08 -6.54296559294E-08 -6.74222609520E-08 -6.94755485679E-08 -7.15913667722E-08 -7.37716198369E-08 -7.60182700238E-08 -7.83333393511E-08 -8.07189114127E-08 -8.31771332533E-08 -8.57102173005E-08 -8.83204433561E-08 -9.10101606471E-08 -9.37817899405E-08 -9.66378257214E-08 -9.95808384375E-08 -1.02613476813E-07 -1.05738470231E-07 -1.08958631191E-07 -1.12276857839E-07 -1.15696136576E-07 -1.19219544744E-07 -1.22850253396E-07 -1.26591530153E-07 -1.30446742137E-07 -1.34419359008E-07 -1.38512956082E-07 -1.42731217550E-07 -1.47077939792E-07 -1.51557034797E-07 -1.56172533676E-07 -1.60928590297E-07 -1.65829485016E-07 -1.70879628534E-07 -1.76083565864E-07 -1.81445980418E-07 -1.86971698227E-07 -1.92665692276E-07 -1.98533086986E-07 -2.04579162820E-07 -2.10809361036E-07 -2.17229288583E-07 -2.23844723147E-07 -2.30661618347E-07 -2.37686109093E-07 -2.44924517109E-07 -2.52383356614E-07 -2.60069340192E-07 -2.67989384825E-07 -2.76150618116E-07 -2.84560384710E-07 -2.93226252890E-07 -3.02156021399E-07 -3.11357726445E-07 -3.20839648941E-07 -3.30610321947E-07 -3.40678538354E-07 -3.51053358789E-07 -3.61744119771E-07 -3.72760442109E-07 -3.84112239555E-07 -3.95809727727E-07 -4.07863433298E-07 -4.20284203464E-07 -4.33083215704E-07 -4.46271987836E-07 -4.59862388377E-07 -4.73866647220E-07 -4.88297366637E-07 -5.03167532615E-07 -5.18490526537E-07 -5.34280137218E-07 -5.50550573314E-07 -5.67316476096E-07 -5.84592932625E-07 -6.02395489320E-07 -6.20740165946E-07 -6.39643470019E-07 -6.59122411654E-07 -6.79194518871E-07 -6.99877853353E-07 -7.21191026696E-07 -7.43153217147E-07 -7.65784186853E-07 -7.89104299636E-07 -8.13134539308E-07 -8.37896528539E-07 -8.63412548312E-07 -8.89705557952E-07 -9.16799215781E-07 -9.44717900387E-07 -9.73486732557E-07 -1.00313159786E-06 -1.03367916992E-06 -1.06515693443E-06 -1.09759321382E-06 -1.13101719277E-06 -1.16545894443E-06 -1.20094945748E-06 -1.23752066395E-06 -1.27520546799E-06 -1.31403777540E-06 -1.35405252418E-06 -1.39528571587E-06 -1.43777444795E-06 -1.48155694723E-06 -1.52667260413E-06 -1.57316200818E-06 -1.62106698446E-06 -1.67043063121E-06 -1.72129735857E-06 -1.77371292851E-06 -1.82772449597E-06 -1.88338065121E-06 -1.94073146353E-06 -1.99982852624E-06 -2.06072500307E-06 -2.12347567590E-06 -2.18813699404E-06 -2.25476712494E-06 -2.32342600645E-06 -2.39417540073E-06 -2.46707894971E-06 -2.54220223230E-06 -2.61961282329E-06 -2.69938035411E-06 -2.78157657536E-06 -2.86627542130E-06 -2.95355307626E-06 -3.04348804309E-06 -3.13616121368E-06 -3.23165594164E-06 -3.33005811719E-06 -3.43145624427E-06 -3.53594152008E-06 -3.64360791696E-06 -3.75455226683E-06 -3.86887434813E-06 -3.98667697544E-06 -4.10806609181E-06 -4.23315086388E-06 -4.36204377996E-06 -4.49486075097E-06 -4.63172121456E-06 -4.77274824233E-06 -4.91806865032E-06 -5.06781311287E-06 -5.22211627991E-06 -5.38111689784E-06 -5.54495793406E-06 -5.71378670530E-06 -5.88775500983E-06 -6.06701926371E-06 -6.25174064111E-06 -6.44208521898E-06 -6.63822412608E-06 -6.84033369647E-06 -7.04859562775E-06 -7.26319714406E-06 -7.48433116401E-06 -7.71219647375E-06 -7.94699790526E-06 -8.18894652006E-06 -8.43825979846E-06 -8.69516183463E-06 -8.95988353751E-06 -9.23266283784E-06 -9.51374490149E-06 -9.80338234923E-06 -1.01018354832E-05 -1.04093725201E-05 -1.07262698318E-05 -1.10528121928E-05 -1.13892930355E-05 -1.17360147132E-05 -1.20932887707E-05 -1.24614362238E-05 -1.28407878465E-05 -1.32316844674E-05 -1.36344772750E-05 -1.40495281320E-05 -1.44772098993E-05 -1.49179067704E-05 -1.53720146142E-05 -1.58399413305E-05 -1.63221072144E-05 -1.68189453324E-05 -1.73309019103E-05 -1.78584367322E-05 -1.84020235516E-05 -1.89621505156E-05 -1.95393206010E-05 -2.01340520645E-05 -2.07468789058E-05 -2.13783513451E-05 -2.20290363147E-05 -2.26995179661E-05 -2.33903981917E-05 -2.41022971627E-05 -2.48358538829E-05 -2.55917267598E-05 -2.63705941924E-05 -2.71731551770E-05 -2.80001299313E-05 -2.88522605370E-05 -2.97303116025E-05 -3.06350709452E-05 -3.15673502937E-05 -3.25279860128E-05 -3.35178398487E-05 -3.45377996976E-05 -3.55887803975E-05 -3.66717245433E-05 -3.77876033270E-05 -3.89374174028E-05 -4.01221977788E-05 -4.13430067349E-05 -4.26009387688E-05 -4.38971215703E-05 -4.52327170251E-05 -4.66089222484E-05 -4.80269706499E-05 -4.94881330312E-05 -5.09937187149E-05 -5.25450767094E-05 -5.41435969073E-05 -5.57907113203E-05 -5.74878953514E-05 -5.92366691050E-05 -6.10385987363E-05 -6.28952978412E-05 -6.48084288883E-05 -6.67797046934E-05 -6.88108899379E-05 -7.09038027337E-05 -7.30603162340E-05 -7.52823602929E-05 -7.75719231744E-05 -7.99310533127E-05 -8.23618611248E-05 -8.48665208782E-05 -8.74472726133E-05 -9.01064241237E-05 -9.28463529963E-05 -9.56695087108E-05 -9.85784148035E-05 -1.01575671095E-04 -1.04663955982E-04 -1.07846028805E-04 -1.11124732273E-04 -1.14502994977E-04 -1.17983833964E-04 -1.21570357396E-04 -1.25265767283E-04 -1.29073362305E-04 -1.32996540704E-04 -1.37038803280E-04 -1.41203756458E-04 -1.45495115459E-04 -1.49916707558E-04 -1.54472475443E-04 -1.59166480667E-04 -1.64002907208E-04 -1.68986065137E-04 -1.74120394380E-04 -1.79410468609E-04 -1.84860999239E-04 -1.90476839537E-04 -1.96262988867E-04 -2.02224597045E-04 -2.08366968832E-04 -2.14695568556E-04 -2.21216024866E-04 -2.27934135634E-04 -2.34855872993E-04 -2.41987388525E-04 -2.49335018602E-04 -2.56905289886E-04 -2.64704924980E-04 -2.72740848255E-04 -2.81020191844E-04 -2.89550301804E-04 -2.98338744467E-04 -3.07393312970E-04 -3.16722033975E-04 -3.26333174589E-04 -3.36235249477E-04 -3.46437028188E-04 -3.56947542688E-04 -3.67776095116E-04 -3.78932265758E-04 -3.90425921255E-04 -4.02267223047E-04 -4.14466636056E-04 -4.27034937628E-04 -4.39983226717E-04 -4.53322933348E-04 -4.67065828339E-04 -4.81224033304E-04 -4.95810030947E-04 -5.10836675638E-04 -5.26317204305E-04 -5.42265247618E-04 -5.58694841504E-04 -5.75620438983E-04 -5.93056922335E-04 -6.11019615618E-04 -6.29524297531E-04 -6.48587214641E-04 -6.68225094985E-04 -6.88455162049E-04 -7.09295149134E-04 -7.30763314133E-04 -7.52878454708E-04 -7.75659923899E-04 -7.99127646154E-04 -8.23302133812E-04 -8.48204504039E-04 -8.73856496221E-04 -9.00280489849E-04 -9.27499522880E-04 -9.55537310609E-04 -9.84418265047E-04 -1.01416751484E-03 -1.04481092569E-03 -1.07637512139E-03 -1.10888750538E-03 -1.14237628285E-03 -1.17687048354E-03 -1.21239998502E-03 -1.24899553671E-03 -1.28668878444E-03 -1.32551229568E-03 -1.36549958549E-03 -1.40668514309E-03 -1.44910445912E-03 -1.49279405366E-03 -1.53779150492E-03 -1.58413547869E-03 -1.63186575856E-03 -1.68102327687E-03 -1.73165014652E-03 -1.78378969346E-03 -1.83748649014E-03 -1.89278638968E-03 -1.94973656098E-03 -2.00838552459E-03 -2.06878318957E-03 -2.13098089118E-03 -2.19503142954E-03 -2.26098910912E-03 -2.32890977931E-03 -2.39885087583E-03 -2.47087146320E-03 -2.54503227816E-03 -2.62139577409E-03 -2.70002616650E-03 -2.78098947951E-03 -2.86435359337E-03 -2.95018829310E-03 -3.03856531815E-03 -3.12955841314E-03 -3.22324337978E-03 -3.31969812980E-03 -3.41900273906E-03 -3.52123950276E-03 -3.62649299180E-03 -3.73485011027E-03 -3.84640015412E-03 -3.96123487092E-03 -4.07944852085E-03 -4.20113793878E-03 -4.32640259756E-03 -4.45534467245E-03 -4.58806910666E-03 -4.72468367809E-03 -4.86529906720E-03 -5.01002892596E-03 -5.15898994796E-03 -5.31230193964E-03 -5.47008789248E-03 -5.63247405641E-03 -5.79959001413E-03 -5.97156875649E-03 -6.14854675880E-03 -6.33066405814E-03 -6.51806433146E-03 -6.71089497467E-03 -6.90930718234E-03 -7.11345602835E-03 -7.32350054702E-03 -7.53960381500E-03 -7.76193303363E-03 -7.99065961174E-03 -8.22595924888E-03 -8.46801201878E-03 -8.71700245299E-03 -8.97311962460E-03 -9.23655723185E-03 -9.50751368164E-03 -9.78619217262E-03 -1.00728007779E-02 -1.03675525269E-02 -1.06706654868E-02 -1.09823628426E-02 -1.13028729761E-02 -1.16324295437E-02 -1.19712715521E-02 -1.23196434326E-02 -1.26777951132E-02 -1.30459820879E-02 -1.34244654837E-02 -1.38135121247E-02 -1.42133945925E-02 -1.46243912830E-02 -1.50467864596E-02 -1.54808703013E-02 -1.59269389462E-02 -1.63852945305E-02 -1.68562452200E-02 -1.73401052374E-02 -1.78371948812E-02 -1.83478405381E-02 -1.88723746877E-02 -1.94111358979E-02 -1.99644688121E-02 -2.05327241259E-02 -2.11162585538E-02 -2.17154347841E-02 -2.23306214225E-02 -2.29621929223E-02 -2.36105295011E-02 -2.42760170426E-02 -2.49590469837E-02 -2.56600161838E-02 -2.63793267778E-02 -2.71173860095E-02 -2.78746060457E-02 -2.86514037692E-02 -2.94482005499E-02 -3.02654219921E-02 -3.11034976568E-02 -3.19628607589E-02 -3.28439478354E-02 -3.37471983857E-02 -3.46730544807E-02 -3.56219603394E-02 -3.65943618724E-02 -3.75907061895E-02 -3.86114410693E-02 -3.96570143907E-02 -4.07278735227E-02 -4.18244646714E-02 -4.29472321821E-02 -4.40966177944E-02 -4.52730598485E-02 -4.64769924398E-02 -4.77088445214E-02 -4.89690389494E-02 -5.02579914727E-02 -5.15761096606E-02 -5.29237917703E-02 -5.43014255485E-02 -5.57093869673E-02 -5.71480388901E-02 -5.86177296675E-02 -6.01187916584E-02 -6.16515396767E-02 -6.32162693592E-02 -6.48132554537E-02 -6.64427500258E-02 -6.81049805813E-02 -6.98001481026E-02 -7.15284249987E-02 -7.32899529651E-02 -7.50848407548E-02 -7.69131618565E-02 -7.87749520817E-02 -8.06702070579E-02 -8.25988796289E-02 -8.45608771617E-02 -8.65560587599E-02 -8.85842323850E-02 -9.06451518862E-02 -9.27385139406E-02 -9.48639549055E-02 -9.70210475861E-02 -9.92092979209E-02 -1.01428141590E-01 -1.03676940552E-01 -1.05954979507E-01 -1.08261462306E-01 -1.10595508304E-01 -1.12956148661E-01 -1.15342322616E-01 -1.17752873723E-01 -1.20186546083E-01 -1.22641980564E-01 -1.25117711036E-01 -1.27612160629E-01 -1.30123638038E-01 -1.32650333884E-01 -1.35190317155E-01 -1.37741531752E-01 -1.40301793152E-01 -1.42868785224E-01 -1.45440057216E-01 -1.48013020944E-01 -1.50584948212E-01 -1.53152968496E-01 -1.55714066919E-01 -1.58265082562E-01 -1.60802707136E-01 -1.63323484063E-01 -1.65823808003E-01 -1.68299924863E-01 -1.70747932341E-01 -1.73163781041E-01 -1.75543276210E-01 -1.77882080140E-01 -1.80175715288E-01 -1.82419568152E-01 -1.84608893966E-01 -1.86738822247E-01 -1.88804363256E-01 -1.90800415411E-01 -1.92721773703E-01 -1.94563139159E-01 -1.96319129392E-01 -1.97984290283E-01 -1.99553108833E-01 -2.01020027199E-01 -2.02379457980E-01 -2.03625800730E-01 -2.04753459755E-01 -2.05756863176E-01 -2.06630483278E-01 -2.07368858122E-01 -2.07966614423E-01 -2.08418491647E-01 -2.08719367304E-01 -2.08864283379E-01 -2.08848473843E-01 -2.08667393155E-01 -2.08316745679E-01 -2.07792515887E-01 -2.07090999247E-01 -2.06208833631E-01 -2.05143031099E-01 -2.03891009874E-01 -2.02450626316E-01 -2.00820206679E-01 -1.98998578424E-01 -1.96985100825E-01 -1.94779694627E-01 -1.92382870441E-01 -1.89795755609E-01 -1.87020119209E-01 -1.84058394886E-01 -1.80913701179E-01 -1.77589858994E-01 -1.74091405905E-01 -1.70423606914E-01 -1.66592461357E-01 -1.62604705601E-01 -1.58467811239E-01 -1.54189978456E-01 -1.49780124308E-01 -1.45247865646E-01 -1.40603496469E-01 -1.35857959537E-01 -1.31022812077E-01 -1.26110185537E-01 -1.21132739310E-01 -1.16103608497E-01 -1.11036345771E-01 -1.05944857530E-01 -1.00843334565E-01 -9.57461775504E-02 -9.06679177731E-02 -8.56231335489E-02 -8.06263628933E-02 -7.56920130738E-02 -7.08342677491E-02 -6.60669924731E-02 -6.14036394058E-02 -5.68571521286E-02 -5.24398715117E-02 -4.81634436157E-02 -4.40387306360E-02 -4.00757259071E-02 -3.62834739796E-02 -3.26699967625E-02 -2.92422266844E-02 -2.60059477711E-02 -2.29657454661E-02 -2.01249659272E-02 -1.74856854283E-02 -1.50486903689E-02 -1.28134682625E-02 -1.07782099207E-02 -8.93982289563E-03 -7.29395607579E-03 -5.83503516256E-03 -4.55630858265E-03 -3.44990322557E-03 -2.50688923256E-03 -1.71735291020E-03 -1.07047670100E-03 -5.54625016367E-04 -1.57434627447E-04 1.34091781535E-04 3.33490364102E-04 4.54740682667E-04 5.12171643672E-04 5.20370344930E-04 4.94095363681E-04 4.46882541098E-04 3.86834887276E-04 3.20137906922E-04 2.52229619131E-04 1.87706615282E-04 1.30232806342E-04 8.24516827094E-05 4.59029390563E-05 2.09443593982E-05 6.67990125097E-06 8.94976731719E-07 1.49665610908E-17 1.59101512879E-17 -6.30505474079E-18 2.77514075059E-17 -6.18044724004E-18 -2.18767233387E-17 -1.09445829614E-17 -7.33791875320E-18 2.61767506340E-17 2.67373743904E-17 1.55219688762E-17 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1 4 1 i j (l(j)) 0.00000000000E+00 Q_int -9.95688390422E-11 -1.02601161214E-10 -1.05725831323E-10 -1.08945661781E-10 -1.12263550652E-10 -1.15682484257E-10 -1.19205539865E-10 -1.22835888462E-10 -1.26576797606E-10 -1.30431634363E-10 -1.34403868345E-10 -1.38497074829E-10 -1.42714937973E-10 -1.47061254136E-10 -1.51539935293E-10 -1.56155012557E-10 -1.60910639805E-10 -1.65811097419E-10 -1.70860796138E-10 -1.76064281028E-10 -1.81426235573E-10 -1.86951485889E-10 -1.92645005070E-10 -1.98511917663E-10 -2.04557504281E-10 -2.10787206354E-10 -2.17206631029E-10 -2.23821556216E-10 -2.30637935789E-10 -2.37661904942E-10 -2.44899785715E-10 -2.52358092682E-10 -2.60043538817E-10 -2.67963041531E-10 -2.76123728903E-10 -2.84532946094E-10 -2.93198261958E-10 -3.02127475856E-10 -3.11328624671E-10 -3.20809990050E-10 -3.30580105849E-10 -3.40647765821E-10 -3.51022031527E-10 -3.61712240495E-10 -3.72728014619E-10 -3.84079268826E-10 -3.95776219997E-10 -4.07829396162E-10 -4.20249645975E-10 -4.33048148484E-10 -4.46236423186E-10 -4.59826340399E-10 -4.73830131947E-10 -4.88260402166E-10 -5.03130139251E-10 -5.18452726945E-10 -5.34241956589E-10 -5.50512039527E-10 -5.67277619907E-10 -5.84553787853E-10 -6.02356093054E-10 -6.20700558754E-10 -6.39603696177E-10 -6.59082519389E-10 -6.79154560608E-10 -6.99837885988E-10 -7.21151111878E-10 -7.43113421577E-10 -7.65744582602E-10 -7.89064964479E-10 -8.13095557076E-10 -8.37857989496E-10 -8.63374549547E-10 -8.89668203796E-10 -9.16762618248E-10 -9.44682179641E-10 -9.73452017398E-10 -1.00309802625E-09 -1.03364688952E-09 -1.06512610318E-09 -1.09756400056E-09 -1.13098977788E-09 -1.16543352050E-09 -1.20092623003E-09 -1.23749985218E-09 -1.27518730560E-09 -1.31402251141E-09 -1.35404042383E-09 -1.39527706153E-09 -1.43776954016E-09 -1.48155610568E-09 -1.52667616881E-09 -1.57317034050E-09 -1.62108046851E-09 -1.67044967500E-09 -1.72132239543E-09 -1.77374441849E-09 -1.82776292736E-09 -1.88342654215E-09 -1.94078536364E-09 -1.99989101843E-09 -2.06079670538E-09 -2.12355724345E-09 -2.18822912113E-09 -2.25487054718E-09 -2.32354150312E-09 -2.39430379713E-09 -2.46722111975E-09 -2.54235910115E-09 -2.61978537026E-09 -2.69956961556E-09 -2.78178364789E-09 -2.86650146501E-09 -2.95379931827E-09 -3.04375578117E-09 -3.13645182014E-09 -3.23197086737E-09 -3.33039889595E-09 -3.43182449719E-09 -3.53633896041E-09 -3.64403635509E-09 -3.75501361551E-09 -3.86937062804E-09 -3.98721032100E-09 -4.10863875735E-09 -4.23376523011E-09 -4.36270236072E-09 -4.49556620047E-09 -4.63247633487E-09 -4.77355599135E-09 -4.91893215014E-09 -5.06873565853E-09 -5.22310134873E-09 -5.38216815910E-09 -5.54607925930E-09 -5.71498217913E-09 -5.88902894127E-09 -6.06837619815E-09 -6.25318537293E-09 -6.44362280478E-09 -6.63985989863E-09 -6.84207327937E-09 -7.05044495090E-09 -7.26516245990E-09 -7.48641906461E-09 -7.71441390882E-09 -7.94935220107E-09 -8.19144539937E-09 -8.44091140150E-09 -8.69797474114E-09 -8.96286678996E-09 -9.23582596585E-09 -9.51709794751E-09 -9.80693589559E-09 -1.01056006805E-08 -1.04133611173E-08 -1.07304942075E-08 -1.10572853884E-08 -1.13940287901E-08 -1.17410275003E-08 -1.20985938368E-08 -1.24670496286E-08 -1.28467265061E-08 -1.32379661988E-08 -1.36411208435E-08 -1.40565533008E-08 -1.44846374820E-08 -1.49257586856E-08 -1.53803139436E-08 -1.58487123796E-08 -1.63313755764E-08 -1.68287379559E-08 -1.73412471696E-08 -1.78693645019E-08 -1.84135652851E-08 -1.89743393273E-08 -1.95521913531E-08 -2.01476414578E-08 -2.07612255760E-08 -2.13934959632E-08 -2.20450216933E-08 -2.27163891709E-08 -2.34082026586E-08 -2.41210848213E-08 -2.48556772863E-08 -2.56126412208E-08 -2.63926579273E-08 -2.71964294562E-08 -2.80246792382E-08 -2.88781527352E-08 -2.97576181109E-08 -3.06638669226E-08 -3.15977148335E-08 -3.25600023466E-08 -3.35515955612E-08 -3.45733869527E-08 -3.56262961755E-08 -3.67112708906E-08 -3.78292876188E-08 -3.89813526196E-08 -4.01685027962E-08 -4.13918066296E-08 -4.26523651395E-08 -4.39513128755E-08 -4.52898189382E-08 -4.66690880313E-08 -4.80903615457E-08 -4.95549186770E-08 -5.10640775766E-08 -5.26191965379E-08 -5.42216752187E-08 -5.58729559013E-08 -5.75745247899E-08 -5.93279133485E-08 -6.11346996791E-08 -6.29965099419E-08 -6.49150198189E-08 -6.68919560215E-08 -6.89290978453E-08 -7.10282787704E-08 -7.31913881122E-08 -7.54203727214E-08 -7.77172387360E-08 -8.00840533869E-08 -8.25229468581E-08 -8.50361142037E-08 -8.76258173238E-08 -9.02943869992E-08 -9.30442249898E-08 -9.58778061956E-08 -9.87976808839E-08 -1.01806476984E-07 -1.04906902454E-07 -1.08101747714E-07 -1.11393888162E-07 -1.14786286757E-07 -1.18281996689E-07 -1.21884164123E-07 -1.25596031034E-07 -1.29420938123E-07 -1.33362327821E-07 -1.37423747391E-07 -1.41608852116E-07 -1.45921408591E-07 -1.50365298112E-07 -1.54944520169E-07 -1.59663196042E-07 -1.64525572516E-07 -1.69536025695E-07 -1.74699064944E-07 -1.80019336949E-07 -1.85501629893E-07 -1.91150877768E-07 -1.96972164814E-07 -2.02970730093E-07 -2.09151972207E-07 -2.15521454151E-07 -2.22084908322E-07 -2.28848241674E-07 -2.35817541038E-07 -2.42999078595E-07 -2.50399317520E-07 -2.58024917799E-07 -2.65882742222E-07 -2.73979862557E-07 -2.82323565911E-07 -2.90921361292E-07 -2.99780986360E-07 -3.08910414394E-07 -3.18317861461E-07 -3.28011793811E-07 -3.38000935497E-07 -3.48294276219E-07 -3.58901079416E-07 -3.69830890600E-07 -3.81093545943E-07 -3.92699181130E-07 -4.04658240472E-07 -4.16981486311E-07 -4.29680008695E-07 -4.42765235359E-07 -4.56248942009E-07 -4.70143262910E-07 -4.84460701808E-07 -4.99214143175E-07 -5.14416863806E-07 -5.30082544757E-07 -5.46225283655E-07 -5.62859607384E-07 -5.80000485147E-07 -5.97663341939E-07 -6.15864072417E-07 -6.34619055204E-07 -6.53945167618E-07 -6.73859800859E-07 -6.94380875647E-07 -7.15526858348E-07 -7.37316777583E-07 -7.59770241344E-07 -7.82907454632E-07 -8.06749237631E-07 -8.31317044436E-07 -8.56632982349E-07 -8.82719831767E-07 -9.09601066666E-07 -9.37300875720E-07 -9.65844184054E-07 -9.95256675661E-07 -1.02556481651E-06 -1.05679587832E-06 -1.08897796315E-06 -1.12214002859E-06 -1.15631191387E-06 -1.19152436667E-06 -1.22780907076E-06 -1.26519867452E-06 -1.30372682028E-06 -1.34342817458E-06 -1.38433845934E-06 -1.42649448398E-06 -1.46993417854E-06 -1.51469662775E-06 -1.56082210622E-06 -1.60835211461E-06 -1.65732941697E-06 -1.70779807917E-06 -1.75980350856E-06 -1.81339249475E-06 -1.86861325169E-06 -1.92551546104E-06 -1.98415031679E-06 -2.04457057134E-06 -2.10683058287E-06 -2.17098636424E-06 -2.23709563333E-06 -2.30521786491E-06 -2.37541434415E-06 -2.44774822162E-06 -2.52228457016E-06 -2.59909044328E-06 -2.67823493546E-06 -2.75978924426E-06 -2.84382673431E-06 -2.93042300321E-06 -3.01965594950E-06 -3.11160584264E-06 -3.20635539519E-06 -3.30398983708E-06 -3.40459699220E-06 -3.50826735737E-06 -3.61509418357E-06 -3.72517355981E-06 -3.83860449939E-06 -3.95548902888E-06 -4.07593227979E-06 -4.20004258300E-06 -4.32793156608E-06 -4.45971425356E-06 -4.59550917025E-06 -4.73543844771E-06 -4.87962793392E-06 -5.02820730632E-06 -5.18131018828E-06 -5.33907426909E-06 -5.50164142761E-06 -5.66915785965E-06 -5.84177420928E-06 -6.01964570407E-06 -6.20293229445E-06 -6.39179879732E-06 -6.58641504403E-06 -6.78695603280E-06 -6.99360208582E-06 -7.20653901115E-06 -7.42595826940E-06 -7.65205714565E-06 -7.88503892648E-06 -8.12511308235E-06 -8.37249545565E-06 -8.62740845427E-06 -8.89008125126E-06 -9.16074999034E-06 -9.43965799779E-06 -9.72705600075E-06 -1.00232023521E-05 -1.03283632620E-05 -1.06428130371E-05 -1.09668343261E-05 -1.13007183733E-05 -1.16447652800E-05 -1.19992842732E-05 -1.23645939830E-05 -1.27410227285E-05 -1.31289088115E-05 -1.35286008202E-05 -1.39404579417E-05 -1.43648502833E-05 -1.48021592046E-05 -1.52527776594E-05 -1.57171105470E-05 -1.61955750756E-05 -1.66886011359E-05 -1.71966316856E-05 -1.77201231470E-05 -1.82595458148E-05 -1.88153842777E-05 -1.93881378523E-05 -1.99783210298E-05 -2.05864639365E-05 -2.12131128087E-05 -2.18588304810E-05 -2.25241968899E-05 -2.32098095933E-05 -2.39162843043E-05 -2.46442554423E-05 -2.53943767002E-05 -2.61673216294E-05 -2.69637842412E-05 -2.77844796280E-05 -2.86301446021E-05 -2.95015383542E-05 -3.03994431321E-05 -3.13246649391E-05 -3.22780342546E-05 -3.32604067755E-05 -3.42726641806E-05 -3.53157149175E-05 -3.63904950141E-05 -3.74979689138E-05 -3.86391303365E-05 -3.98150031650E-05 -4.10266423585E-05 -4.22751348940E-05 -4.35616007352E-05 -4.48871938313E-05 -4.62531031461E-05 -4.76605537171E-05 -4.91108077477E-05 -5.06051657316E-05 -5.21449676110E-05 -5.37315939703E-05 -5.53664672654E-05 -5.70510530895E-05 -5.87868614779E-05 -6.05754482514E-05 -6.24184164004E-05 -6.43174175105E-05 -6.62741532312E-05 -6.82903767883E-05 -7.03678945419E-05 -7.25085675918E-05 -7.47143134299E-05 -7.69871076436E-05 -7.93289856692E-05 -8.17420445982E-05 -8.42284450385E-05 -8.67904130302E-05 -8.94302420198E-05 -9.21502948932E-05 -9.49530060695E-05 -9.78408836574E-05 -1.00816511677E-04 -1.03882552346E-04 -1.07041748438E-04 -1.10296925706E-04 -1.13650995385E-04 -1.17106956764E-04 -1.20667899833E-04 -1.24337008019E-04 -1.28117560993E-04 -1.32012937566E-04 -1.36026618671E-04 -1.40162190432E-04 -1.44423347326E-04 -1.48813895438E-04 -1.53337755814E-04 -1.57998967916E-04 -1.62801693173E-04 -1.67750218641E-04 -1.72848960778E-04 -1.78102469319E-04 -1.83515431277E-04 -1.89092675053E-04 -1.94839174677E-04 -2.00760054170E-04 -2.06860592031E-04 -2.13146225867E-04 -2.19622557148E-04 -2.26295356116E-04 -2.33170566823E-04 -2.40254312332E-04 -2.47552900062E-04 -2.55072827298E-04 -2.62820786854E-04 -2.70803672911E-04 -2.79028587022E-04 -2.87502844296E-04 -2.96233979762E-04 -3.05229754917E-04 -3.14498164474E-04 -3.24047443299E-04 -3.33886073555E-04 -3.44022792055E-04 -3.54466597827E-04 -3.65226759904E-04 -3.76312825338E-04 -3.87734627449E-04 -3.99502294309E-04 -4.11626257485E-04 -4.24117261018E-04 -4.36986370680E-04 -4.50244983485E-04 -4.63904837489E-04 -4.77978021855E-04 -4.92476987232E-04 -5.07414556411E-04 -5.22803935301E-04 -5.38658724220E-04 -5.54992929503E-04 -5.71820975451E-04 -5.89157716620E-04 -6.07018450459E-04 -6.25418930312E-04 -6.44375378789E-04 -6.63904501522E-04 -6.84023501306E-04 -7.04750092648E-04 -7.26102516721E-04 -7.48099556754E-04 -7.70760553839E-04 -7.94105423203E-04 -8.18154670923E-04 -8.42929411120E-04 -8.68451383630E-04 -8.94742972178E-04 -9.21827223047E-04 -9.49727864280E-04 -9.78469325411E-04 -1.00807675774E-03 -1.03857605519E-03 -1.06999387569E-03 -1.10235766324E-03 -1.13569567046E-03 -1.17003698187E-03 -1.20541153777E-03 -1.24185015871E-03 -1.27938457074E-03 -1.31804743124E-03 -1.35787235553E-03 -1.39889394415E-03 -1.44114781089E-03 -1.48467061158E-03 -1.52950007362E-03 -1.57567502634E-03 -1.62323543216E-03 -1.67222241852E-03 -1.72267831072E-03 -1.77464666563E-03 -1.82817230617E-03 -1.88330135684E-03 -1.94008128010E-03 -1.99856091365E-03 -2.05879050876E-03 -2.12082176950E-03 -2.18470789306E-03 -2.25050361099E-03 -2.31826523157E-03 -2.38805068320E-03 -2.45991955888E-03 -2.53393316182E-03 -2.61015455214E-03 -2.68864859478E-03 -2.76948200845E-03 -2.85272341598E-03 -2.93844339565E-03 -3.02671453393E-03 -3.11761147938E-03 -3.21121099782E-03 -3.30759202889E-03 -3.40683574377E-03 -3.50902560436E-03 -3.61424742375E-03 -3.72258942807E-03 -3.83414231970E-03 -3.94899934197E-03 -4.06725634513E-03 -4.18901185391E-03 -4.31436713642E-03 -4.44342627458E-03 -4.57629623594E-03 -4.71308694710E-03 -4.85391136852E-03 -4.99888557087E-03 -5.14812881293E-03 -5.30176362092E-03 -5.45991586943E-03 -5.62271486380E-03 -5.79029342406E-03 -5.96278797033E-03 -6.14033860981E-03 -6.32308922519E-03 -6.51118756454E-03 -6.70478533273E-03 -6.90403828426E-03 -7.10910631747E-03 -7.32015357026E-03 -7.53734851705E-03 -7.76086406718E-03 -7.99087766453E-03 -8.22757138840E-03 -8.47113205562E-03 -8.72175132376E-03 -8.97962579539E-03 -9.24495712346E-03 -9.51795211741E-03 -9.79882285036E-03 -1.00877867668E-02 -1.03850667912E-02 -1.06908914369E-02 -1.10054949156E-02 -1.13291172468E-02 -1.16620043684E-02 -1.20044082456E-02 -1.23565869813E-02 -1.27188049252E-02 -1.30913327826E-02 -1.34744477226E-02 -1.38684334852E-02 -1.42735804871E-02 -1.46901859267E-02 -1.51185538864E-02 -1.55589954337E-02 -1.60118287197E-02 -1.64773790751E-02 -1.69559791033E-02 -1.74479687696E-02 -1.79536954876E-02 -1.84735142010E-02 -1.90077874606E-02 -1.95568854966E-02 -2.01211862852E-02 -2.07010756095E-02 -2.12969471130E-02 -2.19092023470E-02 -2.25382508090E-02 -2.31845099736E-02 -2.38484053134E-02 -2.45303703112E-02 -2.52308464597E-02 -2.59502832518E-02 -2.66891381567E-02 -2.74478765844E-02 -2.82269718347E-02 -2.90269050316E-02 -2.98481650421E-02 -3.06912483761E-02 -3.15566590700E-02 -3.24449085485E-02 -3.33565154673E-02 -3.42920055324E-02 -3.52519112965E-02 -3.62367719299E-02 -3.72471329657E-02 -3.82835460157E-02 -3.93465684580E-02 -4.04367630920E-02 -4.15546977614E-02 -4.27009449410E-02 -4.38760812881E-02 -4.50806871534E-02 -4.63153460530E-02 -4.75806440953E-02 -4.88771693646E-02 -5.02055112562E-02 -5.15662597622E-02 -5.29600047050E-02 -5.43873349164E-02 -5.58488373596E-02 -5.73450961912E-02 -5.88766917616E-02 -6.04441995493E-02 -6.20481890285E-02 -6.36892224652E-02 -6.53678536407E-02 -6.70846264977E-02 -6.88400737081E-02 -7.06347151581E-02 -7.24690563485E-02 -7.43435867059E-02 -7.62587778046E-02 -7.82150814926E-02 -8.02129279219E-02 -8.22527234792E-02 -8.43348486128E-02 -8.64596555561E-02 -8.86274659420E-02 -9.08385683078E-02 -9.30932154873E-02 -9.53916218885E-02 -9.77339606548E-02 -1.00120360708E-01 -1.02550903672E-01 -1.05025620675E-01 -1.07544489032E-01 -1.10107428804E-01 -1.12714299236E-01 -1.15364895076E-01 -1.18058942771E-01 -1.20796096545E-01 -1.23575934363E-01 -1.26397953785E-01 -1.29261567698E-01 -1.32166099963E-01 -1.35110780944E-01 -1.38094742955E-01 -1.41117015620E-01 -1.44176521154E-01 -1.47272069578E-01 -1.50402353879E-01 -1.53565945122E-01 -1.56761287538E-01 -1.59986693589E-01 -1.63240339045E-01 -1.66520258073E-01 -1.69824338367E-01 -1.73150316346E-01 -1.76495772434E-01 -1.79858126452E-01 -1.83234633151E-01 -1.86622377921E-01 -1.90018272693E-01 -1.93419052082E-01 -1.96821269810E-01 -2.00221295435E-01 -2.03615311435E-01 -2.06999310693E-01 -2.10369094425E-01 -2.13720270602E-01 -2.17048252911E-01 -2.20348260317E-01 -2.23615317272E-01 -2.26844254631E-01 -2.30029711337E-01 -2.33166136926E-01 -2.36247794921E-01 -2.39268767177E-01 -2.42222959233E-01 -2.45104106742E-01 -2.47905783034E-01 -2.50621407890E-01 -2.53244257566E-01 -2.55767476144E-01 -2.58184088268E-01 -2.60487013302E-01 -2.62669080990E-01 -2.64723048632E-01 -2.66641619846E-01 -2.68417464929E-01 -2.70043242863E-01 -2.71511624974E-01 -2.72815320250E-01 -2.73947102338E-01 -2.74899838184E-01 -2.75666518311E-01 -2.76240288681E-01 -2.76614484098E-01 -2.76782663082E-01 -2.76738644115E-01 -2.76476543164E-01 -2.75990812357E-01 -2.75276279650E-01 -2.74328189330E-01 -2.73142243164E-01 -2.71714641963E-01 -2.70042127353E-01 -2.68122023451E-01 -2.65952278208E-01 -2.63531504063E-01 -2.60859017619E-01 -2.57934877950E-01 -2.54759923195E-01 -2.51335805020E-01 -2.47665020560E-01 -2.43750941397E-01 -2.39597839144E-01 -2.35210907195E-01 -2.30596278182E-01 -2.25761036704E-01 -2.20713226864E-01 -2.15461854207E-01 -2.10016881625E-01 -2.04389218840E-01 -1.98590705115E-01 -1.92634084853E-01 -1.86532975811E-01 -1.80301829705E-01 -1.73955885027E-01 -1.67511111986E-01 -1.60984149534E-01 -1.54392234545E-01 -1.47753123281E-01 -1.41085005387E-01 -1.34406410757E-01 -1.27736109700E-01 -1.21093006972E-01 -1.14496030309E-01 -1.07964014238E-01 -1.01515580035E-01 -9.51690127903E-02 -8.89421366630E-02 -8.28521894746E-02 -7.69156978806E-02 -7.11483544239E-02 -6.55648978285E-02 -6.01789979266E-02 -5.50031466330E-02 -5.00485563813E-02 -4.53250674124E-02 -4.08410652645E-02 -3.66034097476E-02 -3.26173765964E-02 -2.88866128848E-02 -2.54131071524E-02 -2.21971750415E-02 -1.92374610703E-02 -1.65309569841E-02 -1.40730369245E-02 -1.18575094478E-02 -9.87668621273E-03 -8.12146693437E-03 -6.58143999472E-03 -5.24499788505E-03 -4.09946646022E-03 -3.13124679753E-03 -2.32596828211E-03 -1.66865138787E-03 -1.14387848855E-03 -7.35970918805E-04 -4.29170409154E-04 -2.07822941913E-04 -5.65630149325E-05 3.95037435727E-05 9.46216944220E-05 1.21280552422E-04 1.27379881866E-04 1.19124837289E-04 1.01923891407E-04 8.03382642288E-05 5.80428251943E-05 3.77998283220E-05 2.14468393647E-05 9.90020766395E-06 3.17542406087E-06 4.25689811139E-07 -8.50061073582E-18 9.75868445612E-18 -6.41438539755E-18 1.31532328279E-17 1.18655521626E-18 -4.51934384202E-18 -1.48518412338E-18 5.54419187039E-18 -1.62007925987E-18 4.56391965241E-19 3.87793152726E-18 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2 2 0 i j (l(j)) -2.17866371076E+00 Q_int -3.81228185810E-06 -3.88929503359E-06 -3.96786397735E-06 -4.04802011791E-06 -4.12979551876E-06 -4.21322289106E-06 -4.29833560680E-06 -4.38516771212E-06 -4.47375394095E-06 -4.56412972888E-06 -4.65633122733E-06 -4.75039531804E-06 -4.84635962782E-06 -4.94426254356E-06 -5.04414322764E-06 -5.14604163356E-06 -5.24999852192E-06 -5.35605547675E-06 -5.46425492213E-06 -5.57464013916E-06 -5.68725528325E-06 -5.80214540185E-06 -5.91935645238E-06 -6.03893532068E-06 -6.16092983974E-06 -6.28538880884E-06 -6.41236201306E-06 -6.54190024320E-06 -6.67405531610E-06 -6.80888009537E-06 -6.94642851252E-06 -7.08675558855E-06 -7.22991745596E-06 -7.37597138118E-06 -7.52497578750E-06 -7.67699027843E-06 -7.83207566155E-06 -7.99029397283E-06 -8.15170850143E-06 -8.31638381504E-06 -8.48438578569E-06 -8.65578161611E-06 -8.83063986660E-06 -9.00903048247E-06 -9.19102482200E-06 -9.37669568500E-06 -9.56611734194E-06 -9.75936556360E-06 -9.95651765146E-06 -1.01576524686E-05 -1.03628504711E-05 -1.05721937406E-05 -1.07857660166E-05 -1.10036527304E-05 -1.12259410391E-05 -1.14527198605E-05 -1.16840799086E-05 -1.19201137298E-05 -1.21609157404E-05 -1.24065822636E-05 -1.26572115687E-05 -1.29129039102E-05 -1.31737615676E-05 -1.34398888868E-05 -1.37113923215E-05 -1.39883804759E-05 -1.42709641482E-05 -1.45592563747E-05 -1.48533724753E-05 -1.51534300994E-05 -1.54595492731E-05 -1.57718524472E-05 -1.60904645460E-05 -1.64155130176E-05 -1.67471278846E-05 -1.70854417961E-05 -1.74305900810E-05 -1.77827108020E-05 -1.81419448107E-05 -1.85084358042E-05 -1.88823303822E-05 -1.92637781062E-05 -1.96529315586E-05 -2.00499464046E-05 -2.04549814537E-05 -2.08681987234E-05 -2.12897635045E-05 -2.17198444265E-05 -2.21586135257E-05 -2.26062463133E-05 -2.30629218464E-05 -2.35288227991E-05 -2.40041355356E-05 -2.44890501850E-05 -2.49837607170E-05 -2.54884650199E-05 -2.60033649794E-05 -2.65286665596E-05 -2.70645798850E-05 -2.76113193253E-05 -2.81691035801E-05 -2.87381557674E-05 -2.93187035122E-05 -2.99109790376E-05 -3.05152192581E-05 -3.11316658740E-05 -3.17605654679E-05 -3.24021696041E-05 -3.30567349282E-05 -3.37245232705E-05 -3.44058017506E-05 -3.51008428840E-05 -3.58099246912E-05 -3.65333308090E-05 -3.72713506041E-05 -3.80242792883E-05 -3.87924180370E-05 -3.95760741098E-05 -4.03755609730E-05 -4.11911984252E-05 -4.20233127251E-05 -4.28722367222E-05 -4.37383099897E-05 -4.46218789605E-05 -4.55232970655E-05 -4.64429248755E-05 -4.73811302448E-05 -4.83382884587E-05 -4.93147823833E-05 -5.03110026193E-05 -5.13273476573E-05 -5.23642240379E-05 -5.34220465141E-05 -5.45012382170E-05 -5.56022308252E-05 -5.67254647376E-05 -5.78713892493E-05 -5.90404627313E-05 -6.02331528141E-05 -6.14499365744E-05 -6.26913007262E-05 -6.39577418152E-05 -6.52497664177E-05 -6.65678913430E-05 -6.79126438400E-05 -6.92845618085E-05 -7.06841940139E-05 -7.21121003067E-05 -7.35688518469E-05 -7.50550313319E-05 -7.65712332296E-05 -7.81180640167E-05 -7.96961424205E-05 -8.13060996669E-05 -8.29485797326E-05 -8.46242396028E-05 -8.63337495338E-05 -8.80777933213E-05 -8.98570685736E-05 -9.16722869908E-05 -9.35241746493E-05 -9.54134722924E-05 -9.73409356262E-05 -9.93073356222E-05 -1.01313458825E-04 -1.03360107669E-04 -1.05448100795E-04 -1.07578273382E-04 -1.09751477479E-04 -1.11968582346E-04 -1.14230474803E-04 -1.16538059582E-04 -1.18892259692E-04 -1.21294016783E-04 -1.23744291531E-04 -1.26244064013E-04 -1.28794334105E-04 -1.31396121879E-04 -1.34050468014E-04 -1.36758434209E-04 -1.39521103606E-04 -1.42339581231E-04 -1.45214994426E-04 -1.48148493308E-04 -1.51141251223E-04 -1.54194465219E-04 -1.57309356522E-04 -1.60487171027E-04 -1.63729179796E-04 -1.67036679562E-04 -1.70410993253E-04 -1.73853470518E-04 -1.77365488268E-04 -1.80948451224E-04 -1.84603792484E-04 -1.88332974090E-04 -1.92137487615E-04 -1.96018854763E-04 -1.99978627970E-04 -2.04018391032E-04 -2.08139759734E-04 -2.12344382497E-04 -2.16633941039E-04 -2.21010151043E-04 -2.25474762847E-04 -2.30029562144E-04 -2.34676370693E-04 -2.39417047049E-04 -2.44253487305E-04 -2.49187625855E-04 -2.54221436158E-04 -2.59356931536E-04 -2.64596165975E-04 -2.69941234946E-04 -2.75394276243E-04 -2.80957470838E-04 -2.86633043753E-04 -2.92423264950E-04 -2.98330450238E-04 -3.04356962196E-04 -3.10505211123E-04 -3.16777655997E-04 -3.23176805462E-04 -3.29705218824E-04 -3.36365507083E-04 -3.43160333970E-04 -3.50092417013E-04 -3.57164528627E-04 -3.64379497216E-04 -3.71740208310E-04 -3.79249605713E-04 -3.86910692684E-04 -3.94726533134E-04 -4.02700252852E-04 -4.10835040755E-04 -4.19134150160E-04 -4.27600900088E-04 -4.36238676587E-04 -4.45050934088E-04 -4.54041196784E-04 -4.63213060037E-04 -4.72570191819E-04 -4.82116334174E-04 -4.91855304715E-04 -5.01790998147E-04 -5.11927387830E-04 -5.22268527358E-04 -5.32818552186E-04 -5.43581681276E-04 -5.54562218791E-04 -5.65764555804E-04 -5.77193172064E-04 -5.88852637776E-04 -6.00747615432E-04 -6.12882861675E-04 -6.25263229194E-04 -6.37893668668E-04 -6.50779230740E-04 -6.63925068036E-04 -6.77336437224E-04 -6.91018701114E-04 -7.04977330798E-04 -7.19217907835E-04 -7.33746126486E-04 -7.48567795981E-04 -7.63688842843E-04 -7.79115313256E-04 -7.94853375475E-04 -8.10909322295E-04 -8.27289573561E-04 -8.44000678731E-04 -8.61049319492E-04 -8.78442312429E-04 -8.96186611747E-04 -9.14289312044E-04 -9.32757651148E-04 -9.51599013005E-04 -9.70820930626E-04 -9.90431089095E-04 -1.01043732864E-03 -1.03084764775E-03 -1.05167020638E-03 -1.07291332923E-03 -1.09458550899E-03 -1.11669540984E-03 -1.13925187081E-03 -1.16226390936E-03 -1.18574072497E-03 -1.20969170280E-03 -1.23412641745E-03 -1.25905463676E-03 -1.28448632573E-03 -1.31043165047E-03 -1.33690098228E-03 -1.36390490179E-03 -1.39145420313E-03 -1.41955989831E-03 -1.44823322156E-03 -1.47748563382E-03 -1.50732882733E-03 -1.53777473025E-03 -1.56883551148E-03 -1.60052358546E-03 -1.63285161713E-03 -1.66583252699E-03 -1.69947949624E-03 -1.73380597205E-03 -1.76882567290E-03 -1.80455259407E-03 -1.84100101319E-03 -1.87818549593E-03 -1.91612090186E-03 -1.95482239029E-03 -1.99430542637E-03 -2.03458578719E-03 -2.07567956816E-03 -2.11760318932E-03 -2.16037340193E-03 -2.20400729514E-03 -2.24852230279E-03 -2.29393621034E-03 -2.34026716197E-03 -2.38753366777E-03 -2.43575461117E-03 -2.48494925638E-03 -2.53513725610E-03 -2.58633865935E-03 -2.63857391940E-03 -2.69186390195E-03 -2.74622989343E-03 -2.80169360943E-03 -2.85827720337E-03 -2.91600327529E-03 -2.97489488084E-03 -3.03497554048E-03 -3.09626924875E-03 -3.15880048389E-03 -3.22259421752E-03 -3.28767592457E-03 -3.35407159342E-03 -3.42180773619E-03 -3.49091139931E-03 -3.56141017423E-03 -3.63333220837E-03 -3.70670621634E-03 -3.78156149127E-03 -3.85792791652E-03 -3.93583597744E-03 -4.01531677356E-03 -4.09640203087E-03 -4.17912411439E-03 -4.26351604108E-03 -4.34961149283E-03 -4.43744482990E-03 -4.52705110449E-03 -4.61846607463E-03 -4.71172621838E-03 -4.80686874822E-03 -4.90393162587E-03 -5.00295357725E-03 -5.10397410782E-03 -5.20703351825E-03 -5.31217292036E-03 -5.41943425334E-03 -5.52886030038E-03 -5.64049470558E-03 -5.75438199121E-03 -5.87056757528E-03 -5.98909778951E-03 -6.11001989762E-03 -6.23338211402E-03 -6.35923362281E-03 -6.48762459724E-03 -6.61860621945E-03 -6.75223070073E-03 -6.88855130206E-03 -7.02762235514E-03 -7.16949928379E-03 -7.31423862580E-03 -7.46189805519E-03 -7.61253640495E-03 -7.76621369017E-03 -7.92299113168E-03 -8.08293118013E-03 -8.24609754054E-03 -8.41255519739E-03 -8.58237044009E-03 -8.75561088908E-03 -8.93234552239E-03 -9.11264470267E-03 -9.29658020484E-03 -9.48422524426E-03 -9.67565450539E-03 -9.87094417111E-03 -1.00701719526E-02 -1.02734171195E-02 -1.04807605316E-02 -1.06922846697E-02 -1.09080736682E-02 -1.11282133483E-02 -1.13527912510E-02 -1.15818966716E-02 -1.18156206946E-02 -1.20540562289E-02 -1.22972980445E-02 -1.25454428091E-02 -1.27985891259E-02 -1.30568375720E-02 -1.33202907374E-02 -1.35890532650E-02 -1.38632318914E-02 -1.41429354881E-02 -1.44282751040E-02 -1.47193640084E-02 -1.50163177347E-02 -1.53192541256E-02 -1.56282933785E-02 -1.59435580920E-02 -1.62651733133E-02 -1.65932665864E-02 -1.69279680020E-02 -1.72694102468E-02 -1.76177286551E-02 -1.79730612612E-02 -1.83355488521E-02 -1.87053350218E-02 -1.90825662266E-02 -1.94673918414E-02 -1.98599642167E-02 -2.02604387374E-02 -2.06689738820E-02 -2.10857312837E-02 -2.15108757915E-02 -2.19445755340E-02 -2.23870019830E-02 -2.28383300189E-02 -2.32987379977E-02 -2.37684078186E-02 -2.42475249931E-02 -2.47362787156E-02 -2.52348619349E-02 -2.57434714278E-02 -2.62623078730E-02 -2.67915759274E-02 -2.73314843031E-02 -2.78822458462E-02 -2.84440776171E-02 -2.90172009719E-02 -2.96018416457E-02 -3.01982298372E-02 -3.08066002953E-02 -3.14271924064E-02 -3.20602502842E-02 -3.27060228606E-02 -3.33647639786E-02 -3.40367324867E-02 -3.47221923349E-02 -3.54214126725E-02 -3.61346679482E-02 -3.68622380111E-02 -3.76044082140E-02 -3.83614695189E-02 -3.91337186034E-02 -3.99214579701E-02 -4.07249960571E-02 -4.15446473510E-02 -4.23807325016E-02 -4.32335784386E-02 -4.41035184907E-02 -4.49908925063E-02 -4.58960469764E-02 -4.68193351603E-02 -4.77611172124E-02 -4.87217603119E-02 -4.97016387944E-02 -5.07011342864E-02 -5.17206358409E-02 -5.27605400763E-02 -5.38212513173E-02 -5.49031817384E-02 -5.60067515089E-02 -5.71323889418E-02 -5.82805306438E-02 -5.94516216686E-02 -6.06461156721E-02 -6.18644750710E-02 -6.31071712029E-02 -6.43746844896E-02 -6.56675046033E-02 -6.69861306346E-02 -6.83310712638E-02 -6.97028449346E-02 -7.11019800308E-02 -7.25290150555E-02 -7.39844988128E-02 -7.54689905928E-02 -7.69830603593E-02 -7.85272889400E-02 -8.01022682194E-02 -8.17086013356E-02 -8.33469028784E-02 -8.50177990916E-02 -8.67219280777E-02 -8.84599400052E-02 -9.02324973190E-02 -9.20402749545E-02 -9.38839605531E-02 -9.57642546819E-02 -9.76818710559E-02 -9.96375367632E-02 -1.01631992493E-01 -1.03665992765E-01 -1.05740306167E-01 -1.07855715589E-01 -1.10013018462E-01 -1.12213027003E-01 -1.14456568459E-01 -1.16744485356E-01 -1.19077635750E-01 -1.21456893479E-01 -1.23883148422E-01 -1.26357306758E-01 -1.28880291227E-01 -1.31453041394E-01 -1.34076513917E-01 -1.36751682818E-01 -1.39479539753E-01 -1.42261094286E-01 -1.45097374168E-01 -1.47989425616E-01 -1.50938313590E-01 -1.53945122080E-01 -1.57010954392E-01 -1.60136933431E-01 -1.63324201991E-01 -1.66573923048E-01 -1.69887280048E-01 -1.73265477200E-01 -1.76709739775E-01 -1.80221314396E-01 -1.83801469333E-01 -1.87451494806E-01 -1.91172703278E-01 -1.94966429750E-01 -1.98834032064E-01 -2.02776891196E-01 -2.06796411554E-01 -2.10894021275E-01 -2.15071172520E-01 -2.19329341767E-01 -2.23670030102E-01 -2.28094763514E-01 -2.32605093181E-01 -2.37202595754E-01 -2.41888873642E-01 -2.46665555294E-01 -2.51534295470E-01 -2.56496775517E-01 -2.61554703635E-01 -2.66709815137E-01 -2.71963872713E-01 -2.77318666673E-01 -2.82776015194E-01 -2.88337764561E-01 -2.94005789389E-01 -2.99781992853E-01 -3.05668306892E-01 -3.11666692417E-01 -3.17779139500E-01 -3.24007667558E-01 -3.30354325518E-01 -3.36821191978E-01 -3.43410375348E-01 -3.50124013978E-01 -3.56964276272E-01 -3.63933360783E-01 -3.71033496299E-01 -3.78266941896E-01 -3.85635986985E-01 -3.93142951335E-01 -4.00790185067E-01 -4.08580068637E-01 -4.16515012786E-01 -4.24597458468E-01 -4.32829876749E-01 -4.41214768681E-01 -4.49754665146E-01 -4.58452126661E-01 -4.67309743166E-01 -4.76330133757E-01 -4.85515946401E-01 -4.94869857603E-01 -5.04394572035E-01 -5.14092822126E-01 -5.23967367601E-01 -5.34020994985E-01 -5.44256517048E-01 -5.54676772207E-01 -5.65284623875E-01 -5.76082959749E-01 -5.87074691047E-01 -5.98262751687E-01 -6.09650097391E-01 -6.21239704743E-01 -6.33034570160E-01 -6.45037708805E-01 -6.57252153420E-01 -6.69680953085E-01 -6.82327171898E-01 -6.95193887564E-01 -7.08284189909E-01 -7.21601179293E-01 -7.35147964939E-01 -7.48927663156E-01 -7.62943395466E-01 -7.77198286624E-01 -7.91695462532E-01 -8.06438048037E-01 -8.21429164612E-01 -8.36671927916E-01 -8.52169445231E-01 -8.67924812760E-01 -8.83941112806E-01 -9.00221410793E-01 -9.16768752152E-01 -9.33586159063E-01 -9.50676627029E-01 -9.68043121302E-01 -9.85688573139E-01 -1.00361587589E+00 -1.02182788092E+00 -1.04032739330E+00 -1.05911716742E+00 -1.07819990228E+00 -1.09757823669E+00 -1.11725474418E+00 -1.13723192778E+00 -1.15751221454E+00 -1.17809794983E+00 -1.19899139141E+00 -1.22019470332E+00 -1.24170994945E+00 -1.26353908692E+00 -1.28568395921E+00 -1.30814628900E+00 -1.33092767078E+00 -1.35402956318E+00 -1.37745328105E+00 -1.40119998719E+00 -1.42527068391E+00 -1.44966620419E+00 -1.47438720262E+00 -1.49943414604E+00 -1.52480730379E+00 -1.55050673779E+00 -1.57653229219E+00 -1.60288358278E+00 -1.62955998604E+00 -1.65656062792E+00 -1.68388437221E+00 -1.71152980869E+00 -1.73949524092E+00 -1.76777867361E+00 -1.79637779985E+00 -1.82528998786E+00 -1.85451226747E+00 -1.88404131631E+00 -1.91387344565E+00 -1.94400458591E+00 -1.97443027194E+00 -2.00514562794E+00 -2.03614535209E+00 -2.06742370090E+00 -2.09897447338E+00 -2.13079099479E+00 -2.16286610028E+00 -2.19519211828E+00 -2.22776085361E+00 -2.26056357047E+00 -2.29359097526E+00 -2.32683319922E+00 -2.36027978094E+00 -2.39391964885E+00 -2.42774110361E+00 -2.46173180041E+00 -2.49587873141E+00 -2.53016820812E+00 -2.56458584393E+00 -2.59911653674E+00 -2.63374445182E+00 -2.66845300487E+00 -2.70322484537E+00 -2.73804184033E+00 -2.77288505840E+00 -2.80773475450E+00 -2.84257035502E+00 -2.87737044357E+00 -2.91211274755E+00 -2.94677412543E+00 -2.98133055496E+00 -3.01575712235E+00 -3.05002801251E+00 -3.08411650048E+00 -3.11799494419E+00 -3.15163477852E+00 -3.18500651098E+00 -3.21807971900E+00 -3.25082304897E+00 -3.28320421717E+00 -3.31519001283E+00 -3.34674630325E+00 -3.37783804135E+00 -3.40842927564E+00 -3.43848316282E+00 -3.46796198325E+00 -3.49682715928E+00 -3.52503927674E+00 -3.55255810975E+00 -3.57934264895E+00 -3.60535113334E+00 -3.63054108601E+00 -3.65486935374E+00 -3.67829215081E+00 -3.70076510713E+00 -3.72224332084E+00 -3.74268141556E+00 -3.76203360246E+00 -3.78025374730E+00 -3.79729544259E+00 -3.81311208498E+00 -3.82765695807E+00 -3.84088332069E+00 -3.85274450080E+00 -3.86319399508E+00 -3.87218557427E+00 -3.87967339433E+00 -3.88561211344E+00 -3.88995701486E+00 -3.89266413562E+00 -3.89369040091E+00 -3.89299376428E+00 -3.89053335332E+00 -3.88626962082E+00 -3.88016450108E+00 -3.87218157133E+00 -3.86228621772E+00 -3.85044580579E+00 -3.83662985490E+00 -3.82081021621E+00 -3.80296125371E+00 -3.78306002782E+00 -3.76108648087E+00 -3.73702362375E+00 -3.71085772314E+00 -3.68257848834E+00 -3.65217925693E+00 -3.61965717831E+00 -3.58501339402E+00 -3.54825321385E+00 -3.50938628660E+00 -3.46842676411E+00 -3.42539345753E+00 -3.38030998425E+00 -3.33320490424E+00 -3.28411184429E+00 -3.23306960865E+00 -3.18012227455E+00 -3.12531927100E+00 -3.06871543932E+00 -3.01037107379E+00 -2.95035194072E+00 -2.88872927458E+00 -2.82557974935E+00 -2.76098542378E+00 -2.69503365904E+00 -2.62781700739E+00 -2.55943307058E+00 -2.48998432689E+00 -2.41957792574E+00 -2.34832544905E+00 -2.27634263880E+00 -2.20374909014E+00 -2.13066791011E+00 -2.05722534189E+00 -1.98355035489E+00 -1.90977420159E+00 -1.83602994183E+00 -1.76245193617E+00 -1.68917530988E+00 -1.61633538976E+00 -1.54406711634E+00 -1.47250443431E+00 -1.40177966468E+00 -1.33202286230E+00 -1.26336116299E+00 -1.19591812497E+00 -1.12981306942E+00 -1.06516042560E+00 -1.00206908623E+00 -9.40641778991E-01 -8.80974460541E-01 -8.23155739201E-01 -7.67266333036E-01 -7.13378569791E-01 -6.61555935225E-01 -6.11852676273E-01 -5.64313465201E-01 -5.18973130625E-01 -4.75856460835E-01 -4.34978084294E-01 -3.96342431570E-01 -3.59943782143E-01 -3.25766398678E-01 -2.93784750328E-01 -2.63963825581E-01 -2.36259533914E-01 -2.10619194304E-01 -1.86982107258E-01 -1.65280205670E-01 -1.45438778369E-01 -1.27377258818E-01 -1.11010070011E-01 -9.62475152681E-02 -8.29967033658E-02 -7.11624952655E-02 -6.06484587268E-02 -5.13578162485E-02 -4.31943711937E-02 -3.60633966117E-02 -2.98724712201E-02 -2.45322472859E-02 -1.99571357811E-02 -1.60658952032E-02 -1.27821118847E-02 -1.00345614697E-02 -7.75744354821E-03 -5.89048419205E-03 -4.37890436269E-03 -3.17325582883E-03 -2.22913034855E-03 -1.50675240176E-03 -9.70470675186E-04 -5.88168757204E-04 -3.30029085448E-04 -1.66709537627E-04 -7.19880229116E-05 -2.37470642588E-05 -4.15600262987E-06 2.84968279861E-07 -1.12757705410E-06 -2.96415472691E-06 -3.07749639517E-06 -1.72548119509E-06 -3.55360185920E-07 1.01879429674E-17 -2.23555295423E-17 -2.10268943802E-17 2.48847844287E-17 -7.32048201805E-18 4.58316455693E-17 -2.63674962644E-16 -5.51912936945E-17 -5.22773171923E-17 2.35731786304E-18 -3.26231142382E-17 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2 3 1 i j (l(j)) 0.00000000000E+00 Q_int 1.82338342134E-10 1.87891370829E-10 1.93613514396E-10 1.99509923151E-10 2.05585904256E-10 2.11846926501E-10 2.18298625228E-10 2.24946807397E-10 2.31797456818E-10 2.38856739536E-10 2.46131009378E-10 2.53626813675E-10 2.61350899152E-10 2.69310218006E-10 2.77511934155E-10 2.85963429695E-10 2.94672311537E-10 3.03646418259E-10 3.12893827157E-10 3.22422861519E-10 3.32242098114E-10 3.42360374911E-10 3.52786799039E-10 3.63530754975E-10 3.74601912999E-10 3.86010237895E-10 3.97765997917E-10 4.09879774035E-10 4.22362469459E-10 4.35225319447E-10 4.48479901426E-10 4.62138145405E-10 4.76212344715E-10 4.90715167076E-10 5.05659665997E-10 5.21059292524E-10 5.36927907349E-10 5.53279793285E-10 5.70129668120E-10 5.87492697865E-10 6.05384510404E-10 6.23821209563E-10 6.42819389599E-10 6.62396150139E-10 6.82569111574E-10 7.03356430911E-10 7.24776818122E-10 7.46849552981E-10 7.69594502419E-10 7.93032138404E-10 8.17183556365E-10 8.42070494186E-10 8.67715351764E-10 8.94141211175E-10 9.21371857449E-10 9.49431799974E-10 9.78346294561E-10 1.00814136618E-09 1.03884383236E-09 1.07048132736E-09 1.10308232703E-09 1.13667617443E-09 1.17129310623E-09 1.20696427998E-09 1.24372180210E-09 1.28159875677E-09 1.32062923577E-09 1.36084836911E-09 1.40229235667E-09 1.44499850076E-09 1.48900523975E-09 1.53435218260E-09 1.58108014454E-09 1.62923118383E-09 1.67884863957E-09 1.72997717075E-09 1.78266279639E-09 1.83695293705E-09 1.89289645740E-09 1.95054371030E-09 2.00994658206E-09 2.07115853917E-09 2.13423467639E-09 2.19923176640E-09 2.26620831084E-09 2.33522459297E-09 2.40634273198E-09 2.47962673883E-09 2.55514257393E-09 2.63295820646E-09 2.71314367556E-09 2.79577115341E-09 2.88091501010E-09 2.96865188066E-09 3.05906073399E-09 3.15222294393E-09 3.24822236253E-09 3.34714539550E-09 3.44908107999E-09 3.55412116472E-09 3.66236019259E-09 3.77389558571E-09 3.88882773317E-09 4.00726008132E-09 4.12929922692E-09 4.25505501307E-09 4.38464062809E-09 4.51817270738E-09 4.65577143840E-09 4.79756066884E-09 4.94366801811E-09 5.09422499221E-09 5.24936710204E-09 5.40923398545E-09 5.57396953284E-09 5.74372201672E-09 5.91864422515E-09 6.09889359927E-09 6.28463237498E-09 6.47602772898E-09 6.67325192923E-09 6.87648249002E-09 7.08590233172E-09 7.30169994541E-09 7.52406956258E-09 7.75321132991E-09 7.98933148939E-09 8.23264256403E-09 8.48336354905E-09 8.74172010906E-09 9.00794478113E-09 9.28227718409E-09 9.56496423422E-09 9.85626036745E-09 1.01564277684E-08 1.04657366064E-08 1.07844652786E-08 1.11129006604E-08 1.14513383639E-08 1.18000830040E-08 1.21594484723E-08 1.25297582196E-08 1.29113455476E-08 1.33045539080E-08 1.37097372125E-08 1.41272601505E-08 1.45574985182E-08 1.50008395561E-08 1.54576822979E-08 1.59284379296E-08 1.64135301597E-08 1.69133956002E-08 1.74284841599E-08 1.79592594494E-08 1.85061991978E-08 1.90697956836E-08 1.96505561769E-08 2.02490033964E-08 2.08656759799E-08 2.15011289688E-08 2.21559343081E-08 2.28306813608E-08 2.35259774384E-08 2.42424483477E-08 2.49807389540E-08 2.57415137611E-08 2.65254575103E-08 2.73332757955E-08 2.81656956994E-08 2.90234664470E-08 2.99073600805E-08 3.08181721539E-08 3.17567224492E-08 3.27238557141E-08 3.37204424222E-08 3.47473795569E-08 3.58055914181E-08 3.68960304545E-08 3.80196781210E-08 3.91775457614E-08 4.03706755193E-08 4.16001412756E-08 4.28670496155E-08 4.41725408238E-08 4.55177899118E-08 4.69040076746E-08 4.83324417809E-08 4.98043778956E-08 5.13211408374E-08 5.28840957712E-08 5.44946494362E-08 5.61542514125E-08 5.78643954256E-08 5.96266206910E-08 6.14425132989E-08 6.33137076425E-08 6.52418878884E-08 6.72287894927E-08 6.92762007628E-08 7.13859644668E-08 7.35599794925E-08 7.58002025555E-08 7.81086499614E-08 8.04873994195E-08 8.29385919134E-08 8.54644336276E-08 8.80671979333E-08 9.07492274340E-08 9.35129360745E-08 9.63608113129E-08 9.92954163595E-08 1.02319392484E-07 1.05435461392E-07 1.08646427675E-07 1.11955181334E-07 1.15364700383E-07 1.18878053523E-07 1.22498402912E-07 1.26229007005E-07 1.30073223487E-07 1.34034512299E-07 1.38116438747E-07 1.42322676713E-07 1.46657011964E-07 1.51123345552E-07 1.55725697333E-07 1.60468209578E-07 1.65355150707E-07 1.70390919124E-07 1.75580047182E-07 1.80927205256E-07 1.86437205952E-07 1.92115008433E-07 1.97965722885E-07 2.03994615114E-07 2.10207111288E-07 2.16608802817E-07 2.23205451387E-07 2.30002994146E-07 2.37007549044E-07 2.44225420342E-07 2.51663104282E-07 2.59327294939E-07 2.67224890239E-07 2.75362998169E-07 2.83748943176E-07 2.92390272756E-07 3.01294764246E-07 3.10470431824E-07 3.19925533722E-07 3.29668579655E-07 3.39708338482E-07 3.50053846095E-07 3.60714413553E-07 3.71699635457E-07 3.83019398589E-07 3.94683890806E-07 4.06703610208E-07 4.19089374588E-07 4.31852331164E-07 4.45003966609E-07 4.58556117393E-07 4.72520980429E-07 4.86911124052E-07 5.01739499327E-07 5.17019451705E-07 5.32764733030E-07 5.48989513916E-07 5.65708396494E-07 5.82936427561E-07 6.00689112107E-07 6.18982427279E-07 6.37832836752E-07 6.57257305541E-07 6.77273315273E-07 6.97898879914E-07 7.19152561977E-07 7.41053489228E-07 7.63621371895E-07 7.86876520403E-07 8.10839863653E-07 8.35532967847E-07 8.60978055900E-07 8.87198027432E-07 9.14216479373E-07 9.42057727194E-07 9.70746826787E-07 1.00030959701E-06 1.03077264291E-06 1.06216337968E-06 1.09451005729E-06 1.12784178594E-06 1.16218856225E-06 1.19758129622E-06 1.23405183905E-06 1.27163301181E-06 1.31035863498E-06 1.35026355883E-06 1.39138369482E-06 1.43375604789E-06 1.47741874975E-06 1.52241109321E-06 1.56877356747E-06 1.61654789462E-06 1.66577706713E-06 1.71650538653E-06 1.76877850328E-06 1.82264345782E-06 1.87814872290E-06 1.93534424718E-06 1.99428150017E-06 2.05501351851E-06 2.11759495370E-06 2.18208212126E-06 2.24853305138E-06 2.31700754112E-06 2.38756720819E-06 2.46027554641E-06 2.53519798277E-06 2.61240193632E-06 2.69195687881E-06 2.77393439715E-06 2.85840825782E-06 2.94545447320E-06 3.03515136997E-06 3.12757965951E-06 3.22282251054E-06 3.32096562388E-06 3.42209730955E-06 3.52630856619E-06 3.63369316287E-06 3.74434772346E-06 3.85837181349E-06 3.97586802973E-06 4.09694209238E-06 4.22170294023E-06 4.35026282855E-06 4.48273743005E-06 4.61924593894E-06 4.75991117803E-06 4.90485970923E-06 5.05422194732E-06 5.20813227723E-06 5.36672917483E-06 5.53015533148E-06 5.69855778229E-06 5.87208803833E-06 6.05090222282E-06 6.23516121151E-06 6.42503077729E-06 6.62068173924E-06 6.82229011615E-06 7.03003728478E-06 7.24411014290E-06 7.46470127725E-06 7.69200913669E-06 7.92623821056E-06 8.16759921246E-06 8.41630926967E-06 8.67259211825E-06 8.93667830414E-06 9.20880539038E-06 9.48921817053E-06 9.77816888874E-06 1.00759174663E-05 1.03827317354E-05 1.06988876796E-05 1.10246696819E-05 1.13603707801E-05 1.17062929304E-05 1.20627472785E-05 1.24300544390E-05 1.28085447836E-05 1.31985587380E-05 1.36004470873E-05 1.40145712916E-05 1.44413038103E-05 1.48810284366E-05 1.53341406426E-05 1.58010479342E-05 1.62821702169E-05 1.67779401733E-05 1.72888036512E-05 1.78152200644E-05 1.83576628049E-05 1.89166196679E-05 1.94925932901E-05 2.00861016003E-05 2.06976782852E-05 2.13278732679E-05 2.19772532014E-05 2.26464019779E-05 2.33359212521E-05 2.40464309815E-05 2.47785699830E-05 2.55329965057E-05 2.63103888217E-05 2.71114458349E-05 2.79368877077E-05 2.87874565075E-05 2.96639168718E-05 3.05670566949E-05 3.14976878337E-05 3.24566468366E-05 3.34447956933E-05 3.44630226079E-05 3.55122427954E-05 3.65933993023E-05 3.77074638520E-05 3.88554377161E-05 4.00383526117E-05 4.12572716264E-05 4.25132901709E-05 4.38075369608E-05 4.51411750282E-05 4.65154027633E-05 4.79314549888E-05 4.93906040653E-05 5.08941610317E-05 5.24434767792E-05 5.40399432612E-05 5.56849947396E-05 5.73801090693E-05 5.91268090214E-05 6.09266636459E-05 6.27812896768E-05 6.46923529788E-05 6.66615700378E-05 6.86907094976E-05 7.07815937414E-05 7.29361005228E-05 7.51561646449E-05 7.74437796911E-05 7.98009998073E-05 8.22299415394E-05 8.47327857247E-05 8.73117794417E-05 8.99692380182E-05 9.27075471007E-05 9.55291647856E-05 9.84366238151E-05 1.01432533840E-04 1.04519583750E-04 1.07700544074E-04 1.10978269454E-04 1.14355701196E-04 1.17835869890E-04 1.21421898117E-04 1.25117003236E-04 1.28924500253E-04 1.32847804774E-04 1.36890436058E-04 1.41056020147E-04 1.45348293103E-04 1.49771104334E-04 1.54328420026E-04 1.59024326674E-04 1.63863034725E-04 1.68848882323E-04 1.73986339171E-04 1.79280010511E-04 1.84734641221E-04 1.90355120037E-04 1.96146483897E-04 2.02113922422E-04 2.08262782530E-04 2.14598573187E-04 2.21126970300E-04 2.27853821758E-04 2.34785152628E-04 2.41927170500E-04 2.49286270996E-04 2.56869043447E-04 2.64682276733E-04 2.72732965307E-04 2.81028315389E-04 2.89575751355E-04 2.98382922315E-04 3.07457708881E-04 3.16808230144E-04 3.26442850864E-04 3.36370188861E-04 3.46599122641E-04 3.57138799240E-04 3.67998642308E-04 3.79188360432E-04 3.90717955706E-04 4.02597732559E-04 4.14838306846E-04 4.27450615205E-04 4.40445924699E-04 4.53835842743E-04 4.67632327323E-04 4.81847697520E-04 4.96494644353E-04 5.11586241934E-04 5.27135958957E-04 5.43157670538E-04 5.59665670386E-04 5.76674683355E-04 5.94199878353E-04 6.12256881643E-04 6.30861790526E-04 6.50031187444E-04 6.69782154480E-04 6.90132288304E-04 7.11099715551E-04 7.32703108647E-04 7.54961702114E-04 7.77895309344E-04 8.01524339869E-04 8.25869817143E-04 8.50953396835E-04 8.76797385671E-04 9.03424760821E-04 9.30859189850E-04 9.59125051265E-04 9.88247455648E-04 1.01825226741E-03 1.04916612720E-03 1.08101647492E-03 1.11383157345E-03 1.14764053306E-03 1.18247333653E-03 1.21836086494E-03 1.25533492433E-03 1.29342827299E-03 1.33267464965E-03 1.37310880244E-03 1.41476651865E-03 1.45768465545E-03 1.50190117134E-03 1.54745515867E-03 1.59438687696E-03 1.64273778723E-03 1.69255058734E-03 1.74386924828E-03 1.79673905151E-03 1.85120662740E-03 1.90731999470E-03 1.96512860120E-03 2.02468336548E-03 2.08603671986E-03 2.14924265457E-03 2.21435676316E-03 2.28143628920E-03 2.35054017421E-03 2.42172910705E-03 2.49506557462E-03 2.57061391396E-03 2.64844036581E-03 2.72861312972E-03 2.81120242056E-03 2.89628052667E-03 2.98392186963E-03 3.07420306557E-03 3.16720298827E-03 3.26300283391E-03 3.36168618758E-03 3.46333909165E-03 3.56805011590E-03 3.67591042963E-03 3.78701387564E-03 3.90145704621E-03 4.01933936111E-03 4.14076314764E-03 4.26583372288E-03 4.39465947800E-03 4.52735196483E-03 4.66402598470E-03 4.80479967957E-03 4.94979462549E-03 5.09913592853E-03 5.25295232315E-03 5.41137627298E-03 5.57454407432E-03 5.74259596210E-03 5.91567621857E-03 6.09393328470E-03 6.27751987426E-03 6.46659309080E-03 6.66131454744E-03 6.86185048951E-03 7.06837192025E-03 7.28105472943E-03 7.50007982499E-03 7.72563326787E-03 7.95790640986E-03 8.19709603469E-03 8.44340450234E-03 8.69703989655E-03 8.95821617571E-03 9.22715332697E-03 9.50407752379E-03 9.78922128689E-03 1.00828236485E-02 1.03851303203E-02 1.06963938645E-02 1.10168738686E-02 1.13468371235E-02 1.16865578054E-02 1.20363176611E-02 1.23964061961E-02 1.27671208673E-02 1.31487672787E-02 1.35416593800E-02 1.39461196696E-02 1.43624794000E-02 1.47910787874E-02 1.52322672240E-02 1.56864034935E-02 1.61538559903E-02 1.66350029405E-02 1.71302326277E-02 1.76399436195E-02 1.81645449984E-02 1.87044565943E-02 1.92601092194E-02 1.98319449057E-02 2.04204171443E-02 2.10259911260E-02 2.16491439845E-02 2.22903650395E-02 2.29501560418E-02 2.36290314188E-02 2.43275185197E-02 2.50461578616E-02 2.57855033748E-02 2.65461226464E-02 2.73285971638E-02 2.81335225555E-02 2.89615088300E-02 2.98131806110E-02 3.06891773695E-02 3.15901536519E-02 3.25167793021E-02 3.34697396790E-02 3.44497358662E-02 3.54574848751E-02 3.64937198392E-02 3.75591901990E-02 3.86546618764E-02 3.97809174373E-02 4.09387562417E-02 4.21289945793E-02 4.33524657899E-02 4.46100203662E-02 4.59025260395E-02 4.72308678432E-02 4.85959481568E-02 4.99986867241E-02 5.14400206472E-02 5.29209043526E-02 5.44423095268E-02 5.60052250210E-02 5.76106567203E-02 5.92596273768E-02 6.09531764025E-02 6.26923596200E-02 6.44782489682E-02 6.63119321593E-02 6.81945122840E-02 7.01271073623E-02 7.21108498354E-02 7.41468859956E-02 7.62363753498E-02 7.83804899132E-02 8.05804134288E-02 8.28373405074E-02 8.51524756857E-02 8.75270323945E-02 8.99622318359E-02 9.24593017608E-02 9.50194751435E-02 9.76439887479E-02 1.00334081578E-01 1.03090993209E-01 1.05915961991E-01 1.08810223119E-01 1.11775006568E-01 1.14811534876E-01 1.17921020778E-01 1.21104664682E-01 1.24363651977E-01 1.27699150164E-01 1.31112305814E-01 1.34604241331E-01 1.38176051522E-01 1.41828799965E-01 1.45563515168E-01 1.49381186504E-01 1.53282759932E-01 1.57269133471E-01 1.61341152450E-01 1.65499604503E-01 1.69745214310E-01 1.74078638086E-01 1.78500457795E-01 1.83011175105E-01 1.87611205052E-01 1.92300869441E-01 1.97080389944E-01 2.01949880926E-01 2.06909341975E-01 2.11958650134E-01 2.17097551856E-01 2.22325654657E-01 2.27642418484E-01 2.33047146801E-01 2.38538977392E-01 2.44116872898E-01 2.49779611082E-01 2.55525774850E-01 2.61353742029E-01 2.67261674926E-01 2.73247509676E-01 2.79308945416E-01 2.85443433290E-01 2.91648165333E-01 2.97920063243E-01 3.04255767098E-01 3.10651624038E-01 3.17103676966E-01 3.23607653310E-01 3.30158953895E-01 3.36752641992E-01 3.43383432589E-01 3.50045681962E-01 3.56733377617E-01 3.63440128670E-01 3.70159156757E-01 3.76883287563E-01 3.83604943051E-01 3.90316134508E-01 3.97008456497E-01 4.03673081839E-01 4.10300757733E-01 4.16881803144E-01 4.23406107575E-01 4.29863131374E-01 4.36241907690E-01 4.42531046242E-01 4.48718739035E-01 4.54792768166E-01 4.60740515890E-01 4.66548977076E-01 4.72204774224E-01 4.77694175186E-01 4.83003113742E-01 4.88117213188E-01 4.93021813068E-01 4.97701999189E-01 5.02142637063E-01 5.06328408867E-01 5.10243854061E-01 5.13873413729E-01 5.17201478735E-01 5.20212441749E-01 5.22890753171E-01 5.25220980976E-01 5.27187874445E-01 5.28776431758E-01 5.29971971343E-01 5.30760206886E-01 5.31127325825E-01 5.31060071144E-01 5.30545826216E-01 5.29572702395E-01 5.28129629024E-01 5.26206445451E-01 5.23793994610E-01 5.20884217645E-01 5.17470249017E-01 5.13546511463E-01 5.09108810122E-01 5.04154425077E-01 4.98682201521E-01 4.92692636671E-01 4.86187962542E-01 4.79172223599E-01 4.71651348306E-01 4.63633213520E-01 4.55127700674E-01 4.46146742648E-01 4.36704360249E-01 4.26816687194E-01 4.16501982512E-01 4.05780629330E-01 3.94675119014E-01 3.83210019739E-01 3.71411928599E-01 3.59309406512E-01 3.46932895232E-01 3.34314615988E-01 3.21488449355E-01 3.08489796194E-01 2.95355419668E-01 2.82123268556E-01 2.68832282336E-01 2.55522178740E-01 2.42233224765E-01 2.29005992380E-01 2.15881100467E-01 2.02898944828E-01 1.90099418343E-01 1.77521623697E-01 1.65203581330E-01 1.53181935535E-01 1.41491661873E-01 1.30165779274E-01 1.19235070370E-01 1.08727813746E-01 9.86695318787E-02 8.90827585753E-02 7.99868296815E-02 7.13977007718E-02 6.33277953513E-02 5.57858868882E-02 4.87770176887E-02 4.23024572567E-02 3.63597023268E-02 3.09425202457E-02 2.60410367867E-02 2.16418688370E-02 1.77283016972E-02 1.42805099901E-02 1.12758204007E-02 8.68901367911E-03 6.49266254593E-03 4.65750135870E-03 3.15282265499E-03 1.94689499337E-03 1.00739589274E-03 3.01853141645E-04 -2.01912666127E-04 -5.35351795578E-04 -7.28762788212E-04 -8.10891142658E-04 -8.08556530489E-04 -7.46315372990E-04 -6.46164932023E-04 -5.27294154554E-04 -4.05885342795E-04 -2.94126526111E-04 -1.97973314763E-04 -1.20354760352E-04 -6.22370629391E-05 -2.28234543163E-05 1.70766710839E-07 1.01619109456E-05 1.12543699949E-05 7.70430699024E-06 3.28548278373E-06 5.52798059457E-07 2.96647316966E-18 1.96947210847E-17 -2.47939034354E-17 -2.15292836044E-17 -1.15419506323E-17 5.43799402245E-17 6.22301145784E-17 -2.77019687963E-17 -3.97457925444E-17 -3.29130177078E-18 -5.33032879920E-18 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2 4 1 i j (l(j)) 0.00000000000E+00 Q_int 2.55264669027E-10 2.63038634757E-10 2.71049352951E-10 2.79304033790E-10 2.87810107042E-10 2.96575228743E-10 3.05607288091E-10 3.14914414544E-10 3.24504985140E-10 3.34387632036E-10 3.44571250276E-10 3.55065005800E-10 3.65878343689E-10 3.77020996674E-10 3.88502993888E-10 4.00334669897E-10 4.12526674003E-10 4.25089979824E-10 4.38035895179E-10 4.51376072256E-10 4.65122518108E-10 4.79287605456E-10 4.93884083827E-10 5.08925091026E-10 5.24424164967E-10 5.40395255852E-10 5.56852738730E-10 5.73811426437E-10 5.91286582924E-10 6.09293937000E-10 6.27849696485E-10 6.46970562803E-10 6.66673746010E-10 6.86976980286E-10 7.07898539897E-10 7.29457255642E-10 7.51672531803E-10 7.74564363610E-10 7.98153355239E-10 8.22460738354E-10 8.47508391219E-10 8.73318858391E-10 8.99915371009E-10 9.27321867705E-10 9.55563016151E-10 9.84664235259E-10 1.01465171806E-09 1.04555245529E-09 1.07739425966E-09 1.11020579092E-09 1.14401658161E-09 1.17885706371E-09 1.21475859594E-09 1.25175349209E-09 1.28987505001E-09 1.32915758162E-09 1.36963644382E-09 1.41134807026E-09 1.45433000418E-09 1.49862093215E-09 1.54426071894E-09 1.59129044339E-09 1.63975243535E-09 1.68969031383E-09 1.74114902622E-09 1.79417488875E-09 1.84881562821E-09 1.90512042487E-09 1.96313995676E-09 2.02292644529E-09 2.08453370223E-09 2.14801717818E-09 2.21343401244E-09 2.28084308449E-09 2.35030506690E-09 2.42188248004E-09 2.49563974828E-09 2.57164325801E-09 2.64996141738E-09 2.73066471786E-09 2.81382579773E-09 2.89951950740E-09 2.98782297682E-09 3.07881568490E-09 3.17257953102E-09 3.26919890878E-09 3.36876078193E-09 3.47135476265E-09 3.57707319222E-09 3.68601122412E-09 3.79826690968E-09 3.91394128632E-09 4.03313846849E-09 4.15596574142E-09 4.28253365763E-09 4.41295613646E-09 4.54735056659E-09 4.68583791173E-09 4.82854281944E-09 4.97559373337E-09 5.12712300885E-09 5.28326703201E-09 5.44416634255E-09 5.60996576021E-09 5.78081451515E-09 5.95686638223E-09 6.13827981944E-09 6.32521811053E-09 6.51784951195E-09 6.71634740430E-09 6.92089044837E-09 7.13166274599E-09 7.34885400568E-09 7.57265971343E-09 7.80328130861E-09 8.04092636536E-09 8.28580877931E-09 8.53814896017E-09 8.79817403011E-09 9.06611802814E-09 9.34222212081E-09 9.62673481922E-09 9.91991220273E-09 1.02220181494E-08 1.05333245737E-08 1.08541116708E-08 1.11846681693E-08 1.15252915907E-08 1.18762885173E-08 1.22379748683E-08 1.26106761838E-08 1.29947279183E-08 1.33904757422E-08 1.37982758529E-08 1.42184952959E-08 1.46515122945E-08 1.50977165906E-08 1.55575097957E-08 1.60313057518E-08 1.65195309042E-08 1.70226246855E-08 1.75410399106E-08 1.80752431849E-08 1.86257153238E-08 1.91929517854E-08 1.97774631169E-08 2.03797754137E-08 2.10004307931E-08 2.16399878822E-08 2.22990223206E-08 2.29781272787E-08 2.36779139913E-08 2.43990123081E-08 2.51420712601E-08 2.59077596444E-08 2.66967666255E-08 2.75098023560E-08 2.83475986156E-08 2.92109094699E-08 3.01005119488E-08 3.10172067461E-08 3.19618189401E-08 3.29351987361E-08 3.39382222317E-08 3.49717922054E-08 3.60368389291E-08 3.71343210052E-08 3.82652262297E-08 3.94305724809E-08 4.06314086357E-08 4.18688155138E-08 4.31439068501E-08 4.44578302975E-08 4.58117684594E-08 4.72069399545E-08 4.86446005134E-08 5.01260441086E-08 5.16526041195E-08 5.32256545323E-08 5.48466111765E-08 5.65169329995E-08 5.82381233794E-08 6.00117314782E-08 6.18393536360E-08 6.37226348080E-08 6.56632700447E-08 6.76630060176E-08 6.97236425912E-08 7.18470344433E-08 7.40350927335E-08 7.62897868239E-08 7.86131460514E-08 8.10072615540E-08 8.34742881530E-08 8.60164462924E-08 8.86360240373E-08 9.13353791330E-08 9.41169411273E-08 9.69832135570E-08 9.99367762009E-08 1.02980287402E-07 1.06116486460E-07 1.09348196096E-07 1.12678324995E-07 1.16109870419E-07 1.19645920912E-07 1.23289659072E-07 1.27044364421E-07 1.30913416354E-07 1.34900297179E-07 1.39008595255E-07 1.43242008220E-07 1.47604346315E-07 1.52099535820E-07 1.56731622582E-07 1.61504775658E-07 1.66423291070E-07 1.71491595666E-07 1.76714251108E-07 1.82095957976E-07 1.87641559998E-07 1.93356048413E-07 1.99244566455E-07 2.05312413992E-07 2.11565052286E-07 2.18008108915E-07 2.24647382835E-07 2.31488849597E-07 2.38538666731E-07 2.45803179278E-07 2.53288925510E-07 2.61002642807E-07 2.68951273725E-07 2.77141972241E-07 2.85582110193E-07 2.94279283914E-07 3.03241321067E-07 3.12476287691E-07 3.21992495461E-07 3.31798509163E-07 3.41903154409E-07 3.52315525574E-07 3.63044993981E-07 3.74101216337E-07 3.85494143423E-07 3.97234029046E-07 4.09331439269E-07 4.21797261920E-07 4.34642716389E-07 4.47879363724E-07 4.61519117036E-07 4.75574252220E-07 4.90057419001E-07 5.04981652319E-07 5.20360384055E-07 5.36207455126E-07 5.52537127931E-07 5.69364099194E-07 5.86703513182E-07 6.04570975341E-07 6.22982566330E-07 6.41954856499E-07 6.61504920796E-07 6.81650354132E-07 7.02409287218E-07 7.23800402875E-07 7.45842952849E-07 7.68556775134E-07 7.91962311820E-07 8.16080627493E-07 8.40933428187E-07 8.66543080913E-07 8.92932633790E-07 9.20125836780E-07 9.48147163063E-07 9.77021831053E-07 1.00677582709E-06 1.03743592884E-06 1.06902972935E-06 1.10158566192E-06 1.13513302565E-06 1.16970201184E-06 1.20532373111E-06 1.24203024144E-06 1.27985457697E-06 1.31883077775E-06 1.35899392038E-06 1.40038014952E-06 1.44302671046E-06 1.48697198261E-06 1.53225551403E-06 1.57891805701E-06 1.62700160473E-06 1.67654942908E-06 1.72760611953E-06 1.78021762329E-06 1.83443128665E-06 1.89029589752E-06 1.94786172941E-06 2.00718058658E-06 2.06830585068E-06 2.13129252879E-06 2.19619730286E-06 2.26307858074E-06 2.33199654872E-06 2.40301322564E-06 2.47619251875E-06 2.55160028110E-06 2.62930437087E-06 2.70937471237E-06 2.79188335895E-06 2.87690455780E-06 2.96451481676E-06 3.05479297312E-06 3.14782026455E-06 3.24368040215E-06 3.34245964577E-06 3.44424688160E-06 3.54913370209E-06 3.65721448836E-06 3.76858649508E-06 3.88334993792E-06 4.00160808374E-06 4.12346734341E-06 4.24903736754E-06 4.37843114508E-06 4.51176510498E-06 4.64915922084E-06 4.79073711883E-06 4.93662618888E-06 5.08695769922E-06 5.24186691443E-06 5.40149321710E-06 5.56598023312E-06 5.73547596089E-06 5.91013290436E-06 6.09010821015E-06 6.27556380892E-06 6.46666656087E-06 6.66358840586E-06 6.86650651795E-06 7.07560346472E-06 7.29106737139E-06 7.51309208999E-06 7.74187737360E-06 7.97762905597E-06 8.22055923651E-06 8.47088647102E-06 8.72883596812E-06 8.99463979173E-06 9.26853706962E-06 9.55077420843E-06 9.84160511506E-06 1.01412914250E-05 1.04501027374E-05 1.07683168573E-05 1.10962200458E-05 1.14341072764E-05 1.17822825011E-05 1.21410589228E-05 1.25107592773E-05 1.28917161229E-05 1.32842721395E-05 1.36887804362E-05 1.41056048691E-05 1.45351203677E-05 1.49777132721E-05 1.54337816799E-05 1.59037358041E-05 1.63879983410E-05 1.68870048510E-05 1.74012041486E-05 1.79310587067E-05 1.84770450711E-05 1.90396542891E-05 1.96193923502E-05 2.02167806409E-05 2.08323564124E-05 2.14666732637E-05 2.21203016380E-05 2.27938293356E-05 2.34878620414E-05 2.42030238685E-05 2.49399579190E-05 2.56993268610E-05 2.64818135235E-05 2.72881215096E-05 2.81189758278E-05 2.89751235428E-05 2.98573344464E-05 3.07664017475E-05 3.17031427850E-05 3.26683997603E-05 3.36630404936E-05 3.46879592023E-05 3.57440773036E-05 3.68323442405E-05 3.79537383342E-05 3.91092676612E-05 4.02999709579E-05 4.15269185519E-05 4.27912133218E-05 4.40939916868E-05 4.54364246249E-05 4.68197187237E-05 4.82451172614E-05 4.97139013218E-05 5.12273909426E-05 5.27869462985E-05 5.43939689204E-05 5.60499029513E-05 5.77562364405E-05 5.95145026768E-05 6.13262815623E-05 6.31932010278E-05 6.51169384910E-05 6.70992223588E-05 6.91418335756E-05 7.12466072178E-05 7.34154341369E-05 7.56502626528E-05 7.79531002974E-05 8.03260156122E-05 8.27711399992E-05 8.52906696282E-05 8.78868674027E-05 9.05620649836E-05 9.33186648756E-05 9.61591425763E-05 9.90860487896E-05 1.02102011707E-04 1.05209739358E-04 1.08412022031E-04 1.11711734765E-04 1.15111839924E-04 1.18615389840E-04 1.22225529542E-04 1.25945499566E-04 1.29778638848E-04 1.33728387708E-04 1.37798290920E-04 1.41992000878E-04 1.46313280855E-04 1.50766008365E-04 1.55354178618E-04 1.60081908088E-04 1.64953438186E-04 1.69973139037E-04 1.75145513384E-04 1.80475200596E-04 1.85966980809E-04 1.91625779180E-04 1.97456670279E-04 2.03464882609E-04 2.09655803262E-04 2.16034982714E-04 2.22608139768E-04 2.29381166645E-04 2.36360134224E-04 2.43551297442E-04 2.50961100861E-04 2.58596184394E-04 2.66463389210E-04 2.74569763813E-04 2.82922570303E-04 2.91529290826E-04 3.00397634222E-04 3.09535542863E-04 3.18951199706E-04 3.28653035548E-04 3.38649736510E-04 3.48950251731E-04 3.59563801307E-04 3.70499884460E-04 3.81768287946E-04 3.93379094731E-04 4.05342692910E-04 4.17669784900E-04 4.30371396911E-04 4.43458888694E-04 4.56943963578E-04 4.70838678821E-04 4.85155456250E-04 4.99907093233E-04 5.15106773974E-04 5.30768081142E-04 5.46905007850E-04 5.63531969987E-04 5.80663818920E-04 5.98315854576E-04 6.16503838904E-04 6.35244009747E-04 6.54553095119E-04 6.74448327911E-04 6.94947461030E-04 7.16068782984E-04 7.37831133938E-04 7.60253922236E-04 7.83357141413E-04 8.07161387720E-04 8.31687878153E-04 8.56958469022E-04 8.82995675071E-04 9.09822689153E-04 9.37463402494E-04 9.65942425543E-04 9.95285109452E-04 1.02551756817E-03 1.05666670119E-03 1.08876021699E-03 1.12182665710E-03 1.15589542095E-03 1.19099679140E-03 1.22716196101E-03 1.26442305911E-03 1.30281317964E-03 1.34236640982E-03 1.38311785960E-03 1.42510369206E-03 1.46836115462E-03 1.51292861117E-03 1.55884557517E-03 1.60615274366E-03 1.65489203228E-03 1.70510661132E-03 1.75684094277E-03 1.81014081845E-03 1.86505339929E-03 1.92162725565E-03 1.97991240890E-03 2.03996037408E-03 2.10182420390E-03 2.16555853391E-03 2.23121962899E-03 2.29886543119E-03 2.36855560890E-03 2.44035160740E-03 2.51431670095E-03 2.59051604618E-03 2.66901673717E-03 2.74988786196E-03 2.83320056073E-03 2.91902808555E-03 3.00744586185E-03 3.09853155162E-03 3.19236511833E-03 3.28902889371E-03 3.38860764638E-03 3.49118865231E-03 3.59686176737E-03 3.70571950176E-03 3.81785709655E-03 3.93337260234E-03 4.05236695997E-03 4.17494408363E-03 4.30121094600E-03 4.43127766592E-03 4.56525759828E-03 4.70326742640E-03 4.84542725694E-03 4.99186071723E-03 5.14269505534E-03 5.29806124273E-03 5.45809407966E-03 5.62293230335E-03 5.79271869902E-03 5.96760021385E-03 6.14772807389E-03 6.33325790398E-03 6.52434985085E-03 6.72116870932E-03 6.92388405176E-03 7.13267036086E-03 7.34770716573E-03 7.56917918145E-03 7.79727645214E-03 8.03219449753E-03 8.27413446326E-03 8.52330327474E-03 8.77991379491E-03 9.04418498570E-03 9.31634207346E-03 9.59661671832E-03 9.88524718753E-03 1.01824785329E-02 1.04885627725E-02 1.08037590762E-02 1.11283339557E-02 1.14625614591E-02 1.18067233694E-02 1.21611094072E-02 1.25260174388E-02 1.29017536879E-02 1.32886329519E-02 1.36869788232E-02 1.40971239149E-02 1.45194100907E-02 1.49541887000E-02 1.54018208174E-02 1.58626774870E-02 1.63371399707E-02 1.68256000021E-02 1.73284600443E-02 1.78461335527E-02 1.83790452420E-02 1.89276313579E-02 1.94923399534E-02 2.00736311693E-02 2.06719775188E-02 2.12878641769E-02 2.19217892730E-02 2.25742641885E-02 2.32458138574E-02 2.39369770708E-02 2.46483067853E-02 2.53803704338E-02 2.61337502400E-02 2.69090435358E-02 2.77068630805E-02 2.85278373828E-02 2.93726110249E-02 3.02418449872E-02 3.11362169749E-02 3.20564217452E-02 3.30031714344E-02 3.39771958853E-02 3.49792429728E-02 3.60100789292E-02 3.70704886671E-02 3.81612760989E-02 3.92832644536E-02 4.04372965894E-02 4.16242353006E-02 4.28449636188E-02 4.41003851074E-02 4.53914241473E-02 4.67190262145E-02 4.80841581465E-02 4.94878083973E-02 5.09309872798E-02 5.24147271935E-02 5.39400828363E-02 5.55081313989E-02 5.71199727398E-02 5.87767295390E-02 6.04795474293E-02 6.22295951017E-02 6.40280643839E-02 6.58761702895E-02 6.77751510342E-02 6.97262680184E-02 7.17308057720E-02 7.37900718589E-02 7.59053967380E-02 7.80781335786E-02 8.03096580252E-02 8.26013679091E-02 8.49546829031E-02 8.73710441151E-02 8.98519136170E-02 9.23987739034E-02 9.50131272774E-02 9.76964951572E-02 1.00450417299E-01 1.03276450933E-01 1.06176169803E-01 1.09151163106E-01 1.12203034331E-01 1.15333399981E-01 1.18543888179E-01 1.21836137150E-01 1.25211793572E-01 1.28672510789E-01 1.32219946876E-01 1.35855762552E-01 1.39581618935E-01 1.43399175125E-01 1.47310085608E-01 1.51315997481E-01 1.55418547476E-01 1.59619358784E-01 1.63920037664E-01 1.68322169837E-01 1.72827316640E-01 1.77437010947E-01 1.82152752836E-01 1.86976004998E-01 1.91908187872E-01 1.96950674509E-01 2.02104785143E-01 2.07371781455E-01 2.12752860547E-01 2.18249148581E-01 2.23861694100E-01 2.29591461013E-01 2.35439321239E-01 2.41406046991E-01 2.47492302711E-01 2.53698636633E-01 2.60025471982E-01 2.66473097786E-01 2.73041659319E-01 2.79731148157E-01 2.86541391847E-01 2.93472043194E-01 3.00522569168E-01 3.07692239422E-01 3.14980114450E-01 3.22385033360E-01 3.29905601307E-01 3.37540176564E-01 3.45286857279E-01 3.53143467902E-01 3.61107545335E-01 3.69176324809E-01 3.77346725518E-01 3.85615336055E-01 3.93978399674E-01 4.02431799423E-01 4.10971043195E-01 4.19591248748E-01 4.28287128749E-01 4.37052975908E-01 4.45882648262E-01 4.54769554691E-01 4.63706640745E-01 4.72686374867E-01 4.81700735109E-01 4.90741196440E-01 4.99798718757E-01 5.08863735711E-01 5.17926144483E-01 5.26975296626E-01 5.35999990119E-01 5.44988462787E-01 5.53928387225E-01 5.62806867402E-01 5.71610437106E-01 5.80325060403E-01 5.88936134294E-01 5.97428493759E-01 6.05786419373E-01 6.13993647695E-01 6.22033384621E-01 6.29888321912E-01 6.37540657084E-01 6.44972116880E-01 6.52163984496E-01 6.59097130782E-01 6.65752049580E-01 6.72108897403E-01 6.78147537602E-01 6.83847589194E-01 6.89188480476E-01 6.94149507560E-01 6.98709897915E-01 7.02848878998E-01 7.06545752013E-01 7.09779970821E-01 7.12531225955E-01 7.14779533702E-01 7.16505330124E-01 7.17689569874E-01 7.18313829585E-01 7.18360415588E-01 7.17812475612E-01 7.16654114095E-01 7.14870510648E-01 7.12448041142E-01 7.09374400829E-01 7.05638728820E-01 7.01231733177E-01 6.96145815793E-01 6.90375196151E-01 6.83916032998E-01 6.76766542864E-01 6.68927114311E-01 6.60400416717E-01 6.51191502336E-01 6.41307900327E-01 6.30759701391E-01 6.19559631623E-01 6.07723114155E-01 5.95268317169E-01 5.82216186832E-01 5.68590463765E-01 5.54417681662E-01 5.39727146759E-01 5.24550896912E-01 5.08923639170E-01 4.92882664846E-01 4.76467741232E-01 4.59720979315E-01 4.42686677022E-01 4.25411137784E-01 4.07942464445E-01 3.90330328848E-01 3.72625717718E-01 3.54880655799E-01 3.37147907538E-01 3.19480658994E-01 3.01932181987E-01 2.84555482899E-01 2.67402938911E-01 2.50525924838E-01 2.33974434042E-01 2.17796697306E-01 2.02038803775E-01 1.86744328419E-01 1.71953970636E-01 1.57705208806E-01 1.44031975732E-01 1.30964359888E-01 1.18528337418E-01 1.06745539637E-01 9.56330606151E-02 8.52033090962E-02 7.54639085720E-02 6.64176488591E-02 5.80624918866E-02 5.03916337140E-02 4.33936240022E-02 3.70525432865E-02 3.13482374564E-02 2.62566078420E-02 2.17499542663E-02 1.77973673484E-02 1.43651652744E-02 1.14173691945E-02 8.91621039291E-03 6.82266143054E-03 5.09698260485E-03 3.69927433698E-03 2.59002550467E-03 1.73064732047E-03 1.08398213111E-03 6.14776511569E-04 2.90108268277E-04 7.97574715942E-05 -4.34875719835E-05 -1.03597405753E-04 -1.21148156404E-04 -1.13252768179E-04 -9.29813536522E-05 -6.80891971859E-05 -4.36824059397E-05 -2.30733155356E-05 -7.97831542647E-06 1.23585631631E-06 5.25894230915E-06 5.49996034857E-06 3.71021870799E-06 1.57239828474E-06 2.63322435358E-07 -3.73850352567E-18 -1.06170788718E-17 -2.92830949197E-18 -2.81917040229E-18 8.16796434479E-18 -4.60423597905E-18 2.35364872280E-17 6.07102729068E-18 -2.47302908528E-18 -1.12888722542E-17 2.28839325831E-17 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 3 3 1 i j (l(j)) 2.32996083725E-01 Q_int 1.46953376170E-13 1.52950655925E-13 1.59192689230E-13 1.65689464661E-13 1.72451378437E-13 1.79489251053E-13 1.86814344597E-13 1.94438380772E-13 2.02373559650E-13 2.10632579200E-13 2.19228655602E-13 2.28175544399E-13 2.37487562509E-13 2.47179611132E-13 2.57267199598E-13 2.67766470184E-13 2.78694223945E-13 2.90067947600E-13 3.01905841514E-13 3.14226848821E-13 3.27050685739E-13 3.40397873118E-13 3.54289769282E-13 3.68748604200E-13 3.83797515066E-13 3.99460583315E-13 4.15762873168E-13 4.32730471731E-13 4.50390530746E-13 4.68771310037E-13 4.87902222731E-13 5.07813882325E-13 5.28538151678E-13 5.50108193993E-13 5.72558525888E-13 5.95925072626E-13 6.20245225611E-13 6.45557902213E-13 6.71903608048E-13 6.99324501797E-13 7.27864462665E-13 7.57569160599E-13 7.88486129369E-13 8.20664842631E-13 8.54156793097E-13 8.89015574933E-13 9.25296969520E-13 9.63059034715E-13 1.00236219776E-12 1.04326935197E-12 1.08584595738E-12 1.13016014551E-12 1.17628282835E-12 1.22428781188E-12 1.27425191414E-12 1.32625508816E-12 1.38038054992E-12 1.43671491151E-12 1.49534831970E-12 1.55637460022E-12 1.61989140789E-12 1.68600038290E-12 1.75480731342E-12 1.82642230493E-12 1.90095995637E-12 1.97853954357E-12 2.05928521005E-12 2.14332616572E-12 2.23079689366E-12 2.32183736526E-12 2.41659326424E-12 2.51521621979E-12 2.61786404915E-12 2.72470101023E-12 2.83589806436E-12 2.95163314997E-12 3.07209146722E-12 3.19746577443E-12 3.32795669652E-12 3.46377304603E-12 3.60513215727E-12 3.75226023411E-12 3.90539271191E-12 4.06477463435E-12 4.23066104545E-12 4.40331739774E-12 4.58301997706E-12 4.77005634461E-12 4.96472579715E-12 5.16733984594E-12 5.37822271517E-12 5.59771186084E-12 5.82615851072E-12 6.06392822639E-12 6.31140148821E-12 6.56897430419E-12 6.83705884363E-12 7.11608409671E-12 7.40649656093E-12 7.70876095564E-12 8.02336096561E-12 8.35080001508E-12 8.69160207331E-12 9.04631249304E-12 9.41549888313E-12 9.79975201689E-12 1.01996867774E-11 1.06159431415E-11 1.10491872036E-11 1.15001122421E-11 1.19694398283E-11 1.24579209811E-11 1.29663373689E-11 1.34955025606E-11 1.40462633270E-11 1.46195009960E-11 1.52161328632E-11 1.58371136592E-11 1.64834370778E-11 1.71561373658E-11 1.78562909781E-11 1.85850183001E-11 1.93434854410E-11 2.01329060990E-11 2.09545435041E-11 2.18097124393E-11 2.26997813442E-11 2.36261745053E-11 2.45903743345E-11 2.55939237417E-11 2.66384286036E-11 2.77255603333E-11 2.88570585548E-11 3.00347338869E-11 3.12604708404E-11 3.25362308336E-11 3.38640553311E-11 3.52460691100E-11 3.66844836608E-11 3.81816007251E-11 3.97398159796E-11 4.13616228691E-11 4.30496165968E-11 4.48064982767E-11 4.66350792561E-11 4.85382856139E-11 5.05191628434E-11 5.25808807248E-11 5.47267383980E-11 5.69601696414E-11 5.92847483666E-11 6.17041943374E-11 6.42223791216E-11 6.68433322864E-11 6.95712478465E-11 7.24104909745E-11 7.53656049867E-11 7.84413186125E-11 8.16425535612E-11 8.49744323976E-11 8.84422867387E-11 9.20516657853E-11 9.58083452012E-11 9.97183363553E-11 1.03787895941E-10 1.08023535986E-10 1.12432034275E-10 1.17020445195E-10 1.21796111019E-10 1.26766673661E-10 1.31940086900E-10 1.37324629106E-10 1.42928916491E-10 1.48761916892E-10 1.54832964123E-10 1.61151772909E-10 1.67728454432E-10 1.74573532506E-10 1.81697960424E-10 1.89113138478E-10 1.96830932203E-10 2.04863691363E-10 2.13224269712E-10 2.21926045562E-10 2.30982943190E-10 2.40409455116E-10 2.50220665294E-10 2.60432273249E-10 2.71060619196E-10 2.82122710188E-10 2.93636247324E-10 3.05619654080E-10 3.18092105780E-10 3.31073560285E-10 3.44584789922E-10 3.58647414727E-10 3.73283937031E-10 3.88517777475E-10 4.04373312474E-10 4.20875913232E-10 4.38051986327E-10 4.55929015973E-10 4.74535607987E-10 4.93901535570E-10 5.14057786935E-10 5.35036614899E-10 5.56871588483E-10 5.79597646627E-10 6.03251154092E-10 6.27869959647E-10 6.53493456625E-10 6.80162645958E-10 7.07920201774E-10 7.36810539683E-10 7.66879887838E-10 7.98176360900E-10 8.30750037028E-10 8.64653037997E-10 8.99939612599E-10 9.36666223438E-10 9.74891637269E-10 1.01467701903E-09 1.05608602969E-09 1.09918492812E-09 1.14404267711E-09 1.19073105370E-09 1.23932476399E-09 1.28990156274E-09 1.34254237769E-09 1.39733143911E-09 1.45435641453E-09 1.51370854898E-09 1.57548281104E-09 1.63977804473E-09 1.70669712767E-09 1.77634713567E-09 1.84883951406E-09 1.92429025596E-09 2.00282008789E-09 2.08455466290E-09 2.16962476160E-09 2.25816650142E-09 2.35032155433E-09 2.44623737355E-09 2.54606742941E-09 2.64997145491E-09 2.75811570127E-09 2.87067320385E-09 2.98782405908E-09 3.10975571246E-09 3.23666325853E-09 3.36874975296E-09 3.50622653738E-09 3.64931357747E-09 3.79823981491E-09 3.95324353359E-09 4.11457274082E-09 4.28248556408E-09 4.45725066396E-09 4.63914766394E-09 4.82846759772E-09 5.02551337477E-09 5.23060026495E-09 5.44405640276E-09 5.66622331232E-09 5.89745645367E-09 6.13812579140E-09 6.38861638644E-09 6.64932901205E-09 6.92068079487E-09 7.20310588221E-09 7.49705613647E-09 7.80300185796E-09 8.12143253716E-09 8.45285763775E-09 8.79780741145E-09 9.15683374620E-09 9.53051104898E-09 9.91943716448E-09 1.03242343314E-08 1.07455501779E-08 1.11840587569E-08 1.16404616249E-08 1.21154889637E-08 1.26099007481E-08 1.31244879620E-08 1.36600738628E-08 1.42175152985E-08 1.47977040781E-08 1.54015683979E-08 1.60300743256E-08 1.66842273460E-08 1.73650739686E-08 1.80737034012E-08 1.88112492922E-08 1.95788915432E-08 2.03778581962E-08 2.12094273970E-08 2.20749294398E-08 2.29757488942E-08 2.39133268191E-08 2.48891630675E-08 2.59048186847E-08 2.69619184045E-08 2.80621532471E-08 2.92072832234E-08 3.03991401488E-08 3.16396305726E-08 3.29307388262E-08 3.42745301958E-08 3.56731542249E-08 3.71288481507E-08 3.86439404815E-08 4.02208547191E-08 4.18621132337E-08 4.35703412964E-08 4.53482712764E-08 4.71987470091E-08 4.91247283421E-08 5.11292958677E-08 5.32156558467E-08 5.53871453340E-08 5.76472375133E-08 5.99995472486E-08 6.24478368624E-08 6.49960221496E-08 6.76481786365E-08 7.04085480948E-08 7.32815453212E-08 7.62717651934E-08 7.93839900141E-08 8.26231971537E-08 8.59945670050E-08 8.95034912620E-08 9.31555815362E-08 9.69566783242E-08 1.00912860340E-07 1.05030454231E-07 1.09316044681E-07 1.13776484941E-07 1.18418907769E-07 1.23250736835E-07 1.28279698575E-07 1.33513834542E-07 1.38961514244E-07 1.44631448525E-07 1.50532703471E-07 1.56674714898E-07 1.63067303426E-07 1.69720690157E-07 1.76645513012E-07 1.83852843713E-07 1.91354205471E-07 1.99161591386E-07 2.07287483603E-07 2.15744873244E-07 2.24547281154E-07 2.33708779488E-07 2.43244014187E-07 2.53168228355E-07 2.63497286603E-07 2.74247700373E-07 2.85436654300E-07 2.97082033642E-07 3.09202452836E-07 3.21817285204E-07 3.34946693880E-07 3.48611663991E-07 3.62834036146E-07 3.77636541296E-07 3.93042837002E-07 4.09077545191E-07 4.25766291440E-07 4.43135745863E-07 4.61213665662E-07 4.80028939410E-07 4.99611633131E-07 5.19993038265E-07 5.41205721576E-07 5.63283577091E-07 5.86261880161E-07 6.10177343710E-07 6.35068176780E-07 6.60974145455E-07 6.87936636260E-07 7.15998722146E-07 7.45205231153E-07 7.75602817861E-07 8.07240037762E-07 8.40167424636E-07 8.74437571089E-07 9.10105212358E-07 9.47227313523E-07 9.85863160264E-07 1.02607445331E-06 1.06792540672E-06 1.11148285018E-06 1.15681633540E-06 1.20399824692E-06 1.25310391733E-06 1.30421174725E-06 1.35740333011E-06 1.41276358205E-06 1.47038087708E-06 1.53034718773E-06 1.59275823139E-06 1.65771362263E-06 1.72531703167E-06 1.79567634931E-06 1.86890385851E-06 1.94511641301E-06 2.02443562310E-06 2.10698804901E-06 2.19290540211E-06 2.28232475424E-06 2.37538875564E-06 2.47224586154E-06 2.57305056814E-06 2.67796365799E-06 2.78715245539E-06 2.90079109219E-06 3.01906078422E-06 3.14215011908E-06 3.27025535550E-06 3.40358073482E-06 3.54233880513E-06 3.68675075850E-06 3.83704678190E-06 3.99346642229E-06 4.15625896652E-06 4.32568383656E-06 4.50201100075E-06 4.68552140172E-06 4.87650740155E-06 5.07527324497E-06 5.28213554132E-06 5.49742376588E-06 5.72148078163E-06 5.95466338193E-06 6.19734285526E-06 6.44990557266E-06 6.71275359895E-06 6.98630532864E-06 7.27099614749E-06 7.56727912075E-06 7.87562570919E-06 8.19652651402E-06 8.53049205184E-06 8.87805356084E-06 9.23976383949E-06 9.61619811902E-06 1.00079549711E-05 1.04156572520E-05 1.08399530848E-05 1.12815168814E-05 1.17410504048E-05 1.22192838754E-05 1.27169771208E-05 1.32349207722E-05 1.37739375088E-05 1.43348833524E-05 1.49186490135E-05 1.55261612925E-05 1.61583845357E-05 1.68163221508E-05 1.75010181833E-05 1.82135589548E-05 1.89550747690E-05 1.97267416838E-05 2.05297833566E-05 2.13654729615E-05 2.22351351850E-05 2.31401482999E-05 2.40819463239E-05 2.50620212625E-05 2.60819254434E-05 2.71432739431E-05 2.82477471104E-05 2.93970931911E-05 3.05931310568E-05 3.18377530430E-05 3.31329279004E-05 3.44807038626E-05 3.58832118377E-05 3.73426687255E-05 3.88613808668E-05 4.04417476308E-05 4.20862651438E-05 4.37975301664E-05 4.55782441248E-05 4.74312173015E-05 4.93593731925E-05 5.13657530366E-05 5.34535205246E-05 5.56259666945E-05 5.78865150194E-05 6.02387266981E-05 6.26863061530E-05 6.52331067457E-05 6.78831367176E-05 7.06405653646E-05 7.35097294550E-05 7.64951398995E-05 7.96014886835E-05 8.28336560717E-05 8.61967180955E-05 8.96959543333E-05 9.33368559967E-05 9.71251343318E-05 1.01066729350E-04 1.05167818900E-04 1.09434828091E-04 1.13874439091E-04 1.18493601296E-04 1.23299541902E-04 1.28299776889E-04 1.33502122425E-04 1.38914706720E-04 1.44545982333E-04 1.50404738959E-04 1.56500116710E-04 1.62841619904E-04 1.69439131399E-04 1.76302927460E-04 1.83443693214E-04 1.90872538691E-04 1.98601015485E-04 2.06641134046E-04 2.15005381642E-04 2.23706741004E-04 2.32758709682E-04 2.42175320136E-04 2.51971160598E-04 2.62161396719E-04 2.72761794045E-04 2.83788741332E-04 2.95259274757E-04 3.07191103028E-04 3.19602633452E-04 3.32512998973E-04 3.45942086233E-04 3.59910564675E-04 3.74439916747E-04 3.89552469214E-04 4.05271425657E-04 4.21620900159E-04 4.38625952258E-04 4.56312623178E-04 4.74707973406E-04 4.93840121649E-04 5.13738285222E-04 5.34432821920E-04 5.55955273409E-04 5.78338410215E-04 6.01616278334E-04 6.25824247539E-04 6.50999061432E-04 6.77178889301E-04 7.04403379838E-04 7.32713716788E-04 7.62152676575E-04 7.92764687993E-04 8.24595894003E-04 8.57694215724E-04 8.92109418673E-04 9.27893181335E-04 9.65099166131E-04 1.00378309285E-03 1.04400281466E-03 1.08581839669E-03 1.12929219738E-03 1.17448895257E-03 1.22147586249E-03 1.27032268170E-03 1.32110181203E-03 1.37388839872E-03 1.42876042971E-03 1.48579883824E-03 1.54508760892E-03 1.60671388721E-03 1.67076809250E-03 1.73734403489E-03 1.80653903576E-03 1.87845405217E-03 1.95319380523E-03 2.03086691260E-03 2.11158602511E-03 2.19546796762E-03 2.28263388430E-03 2.37320938839E-03 2.46732471641E-03 2.56511488721E-03 2.66671986558E-03 2.77228473091E-03 2.88195985065E-03 2.99590105891E-03 3.11426984013E-03 3.23723351804E-03 3.36496544989E-03 3.49764522606E-03 3.63545887520E-03 3.77859907484E-03 3.92726536771E-03 4.08166438362E-03 4.24201006722E-03 4.40852391143E-03 4.58143519675E-03 4.76098123647E-03 4.94740762775E-03 5.14096850855E-03 5.34192682063E-03 5.55055457828E-03 5.76713314313E-03 5.99195350465E-03 6.22531656660E-03 6.46753343914E-03 6.71892573670E-03 6.97982588131E-03 7.25057741145E-03 7.53153529624E-03 7.82306625468E-03 8.12554907989E-03 8.43937496812E-03 8.76494785218E-03 9.10268473911E-03 9.45301605175E-03 9.81638597391E-03 1.01932527986E-02 1.05840892791E-02 1.09893829825E-02 1.14096366443E-02 1.18453685255E-02 1.22971127691E-02 1.27654197570E-02 1.32508564667E-02 1.37540068253E-02 1.42754720626E-02 1.48158710595E-02 1.53758406935E-02 1.59560361780E-02 1.65571313955E-02 1.71798192236E-02 1.78248118518E-02 1.84928410880E-02 1.91846586537E-02 1.99010364657E-02 2.06427669032E-02 2.14106630578E-02 2.22055589657E-02 2.30283098189E-02 2.38797921541E-02 2.47609040166E-02 2.56725650975E-02 2.66157168408E-02 2.75913225188E-02 2.86003672724E-02 2.96438581134E-02 3.07228238860E-02 3.18383151849E-02 3.29914042250E-02 3.41831846609E-02 3.54147713519E-02 3.66873000684E-02 3.80019271360E-02 3.93598290135E-02 4.07622017994E-02 4.22102606639E-02 4.37052392004E-02 4.52483886922E-02 4.68409772901E-02 4.84842890935E-02 5.01796231333E-02 5.19282922468E-02 5.37316218427E-02 5.55909485482E-02 5.75076187324E-02 5.94829869012E-02 6.15184139561E-02 6.36152653111E-02 6.57749088617E-02 6.79987127979E-02 7.02880432577E-02 7.26442618102E-02 7.50687227660E-02 7.75627703051E-02 8.01277354169E-02 8.27649326459E-02 8.54756566362E-02 8.82611784685E-02 9.11227417837E-02 9.40615586864E-02 9.70788054237E-02 1.00175617833E-01 1.03353086553E-01 1.06612251997E-01 1.09954099077E-01 1.13379551685E-01 1.16889466917E-01 1.20484629050E-01 1.24165743257E-01 1.27933429070E-01 1.31788213588E-01 1.35730524430E-01 1.39760682431E-01 1.43878894098E-01 1.48085243814E-01 1.52379685816E-01 1.56762035930E-01 1.61231963099E-01 1.65788980693E-01 1.70432437636E-01 1.75161509341E-01 1.79975188494E-01 1.84872275691E-01 1.89851369954E-01 1.94910859162E-01 2.00048910402E-01 2.05263460296E-01 2.10552205314E-01 2.15912592130E-01 2.21341808047E-01 2.26836771530E-01 2.32394122916E-01 2.38010215321E-01 2.43681105819E-01 2.49402546935E-01 2.55169978528E-01 2.60978520108E-01 2.66822963669E-01 2.72697767103E-01 2.78597048269E-01 2.84514579794E-01 2.90443784690E-01 2.96377732867E-01 3.02309138622E-01 3.08230359214E-01 3.14133394586E-01 3.20009888356E-01 3.25851130147E-01 3.31648059372E-01 3.37391270553E-01 3.43071020281E-01 3.48677235906E-01 3.54199526053E-01 3.59627193057E-01 3.64949247402E-01 3.70154424249E-01 3.75231202134E-01 3.80167823913E-01 3.84952320014E-01 3.89572534058E-01 3.94016150900E-01 3.98270727126E-01 4.02323724040E-01 4.06162543141E-01 4.09774564108E-01 4.13147185259E-01 4.16267866470E-01 4.19124174481E-01 4.21703830538E-01 4.23994760264E-01 4.25985145655E-01 4.27663479055E-01 4.29018618955E-01 4.30039847429E-01 4.30716928982E-01 4.31040170591E-01 4.31000482654E-01 4.30589440571E-01 4.29799346615E-01 4.28623291773E-01 4.27055217165E-01 4.25089974647E-01 4.22723386186E-01 4.19952301557E-01 4.16774653899E-01 4.13189512653E-01 4.09197133388E-01 4.04799004003E-01 3.99997886797E-01 3.94797855887E-01 3.89204329460E-01 3.83224096332E-01 3.76865336337E-01 3.70137634037E-01 3.63051985300E-01 3.55620796304E-01 3.47857874564E-01 3.39778411615E-01 3.31398957026E-01 3.22737383487E-01 3.13812842743E-01 3.04645712233E-01 2.95257532352E-01 2.85670934321E-01 2.75909558748E-01 2.65997965010E-01 2.55961531705E-01 2.45826348497E-01 2.35619099754E-01 2.25366940490E-01 2.15097365191E-01 2.04838070220E-01 1.94616810547E-01 1.84461251673E-01 1.74398817666E-01 1.64456536326E-01 1.54660882550E-01 1.45037621041E-01 1.35611649563E-01 1.26406843996E-01 1.17445906468E-01 1.08750217918E-01 1.00339696404E-01 9.22326625635E-02 8.44457135570E-02 7.69936068947E-02 6.98891554760E-02 6.31431351746E-02 5.67642062537E-02 5.07588498438E-02 4.51313206530E-02 3.98836169972E-02 3.50154691440E-02 3.05243468459E-02 2.64054868072E-02 2.26519406707E-02 1.92546439316E-02 1.62025059800E-02 1.34825212397E-02 1.10799011107E-02 8.97822612885E-03 7.15961743904E-03 5.60492632412E-03 4.29394016092E-03 3.20560277331E-03 2.31824673921E-03 1.60983478297E-03 1.05820695952E-03 6.41329921391E-04 3.37544167512E-04 1.25804817107E-04 -1.40888513234E-05 -1.00097106907E-04 -1.44424878218E-04 -1.57303189155E-04 -1.48084441529E-04 -1.25099863694E-04 -9.55179536550E-05 -6.52048892767E-05 -3.85879228958E-05 -1.85228541276E-05 -6.16676083983E-06 -8.57293626921E-07 -2.33758777995E-17 2.52998043059E-18 -2.10896326373E-17 -2.66745717503E-17 -2.71412809960E-17 1.27653207873E-17 4.46253064135E-18 -1.53559578220E-17 1.53672116888E-17 2.45524309930E-17 -6.82414282171E-18 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 3 4 1 i j (l(j)) 2.94991157673E-01 Q_int 1.99011401194E-13 2.07133208748E-13 2.15586473445E-13 2.24384722300E-13 2.33542034377E-13 2.43073063316E-13 2.52993060782E-13 2.63317900876E-13 2.74064105527E-13 2.85248870939E-13 2.96890095108E-13 3.09006406456E-13 3.21617193648E-13 3.34742636612E-13 3.48403738837E-13 3.62622360976E-13 3.77421255835E-13 3.92824104776E-13 4.08855555617E-13 4.25541262068E-13 4.42907924790E-13 4.60983334114E-13 4.79796414517E-13 4.99377270902E-13 5.19757236780E-13 5.40968924399E-13 5.63046276943E-13 5.86024622836E-13 6.09940732284E-13 6.34832876112E-13 6.60740887003E-13 6.87706223241E-13 7.15772035054E-13 7.44983233659E-13 7.75386563134E-13 8.07030675216E-13 8.39966207154E-13 8.74245862739E-13 9.09924496641E-13 9.47059202189E-13 9.85709402731E-13 1.02593694672E-12 1.06780620670E-12 1.11138418229E-12 1.15674060741E-12 1.20394806189E-12 1.25308208757E-12 1.30422130922E-12 1.35744756034E-12 1.41284601410E-12 1.47050531967E-12 1.53051774403E-12 1.59297931964E-12 1.65798999815E-12 1.72565381024E-12 1.79607903222E-12 1.86937835918E-12 1.94566908540E-12 2.02507329201E-12 2.10771804237E-12 2.19373558535E-12 2.28326356702E-12 2.37644525085E-12 2.47342974701E-12 2.57437225094E-12 2.67943429173E-12 2.78878399055E-12 2.90259632974E-12 3.02105343275E-12 3.14434485565E-12 3.27266789037E-12 3.40622788049E-12 3.54523854977E-12 3.68992234420E-12 3.84051078792E-12 3.99724485371E-12 4.16037534863E-12 4.33016331531E-12 4.50688044970E-12 4.69080953585E-12 4.88224489840E-12 5.08149287355E-12 5.28887229929E-12 5.50471502556E-12 5.72936644533E-12 5.96318604726E-12 6.20654799095E-12 6.45984170570E-12 6.72347251363E-12 6.99786227834E-12 7.28345007989E-12 7.58069291749E-12 7.89006644075E-12 8.21206571081E-12 8.54720599255E-12 8.89602357912E-12 9.25907665009E-12 9.63694616466E-12 1.00302367913E-11 1.04395778753E-11 1.08656244461E-11 1.13090582649E-11 1.17705889162E-11 1.22509549429E-11 1.27509250284E-11 1.32712992264E-11 1.38129102411E-11 1.43766247599E-11 1.49633448403E-11 1.55740093529E-11 1.62095954845E-11 1.68711203010E-11 1.75596423755E-11 1.82762634819E-11 1.90221303582E-11 1.97984365410E-11 2.06064242761E-11 2.14473865056E-11 2.23226689374E-11 2.32336721982E-11 2.41818540749E-11 2.51687318476E-11 2.61958847170E-11 2.72649563317E-11 2.83776574185E-11 2.95357685193E-11 3.07411428410E-11 3.19957092206E-11 3.33014752114E-11 3.46605302962E-11 3.60750492299E-11 3.75472955203E-11 3.90796250496E-11 4.06744898447E-11 4.23344420001E-11 4.40621377626E-11 4.58603417809E-11 4.77319315304E-11 4.96799019167E-11 5.17073700687E-11 5.38175803262E-11 5.60139094314E-11 5.82998719322E-11 6.06791258063E-11 6.31554783143E-11 6.57328920921E-11 6.84154914917E-11 7.12075691808E-11 7.41135930118E-11 7.71382131710E-11 8.02862696197E-11 8.35627998391E-11 8.69730468905E-11 9.05224678056E-11 9.42167423181E-11 9.80617819527E-11 1.02063739484E-10 1.06229018781E-10 1.10564285058E-10 1.15076475533E-10 1.19772810536E-10 1.24660805056E-10 1.29748280772E-10 1.35043378565E-10 1.40554571542E-10 1.46290678602E-10 1.52260878541E-10 1.58474724740E-10 1.64942160456E-10 1.71673534727E-10 1.78679618934E-10 1.85971624039E-10 1.93561218520E-10 2.01460547044E-10 2.09682249902E-10 2.18239483229E-10 2.27145940063E-10 2.36415872249E-10 2.46064113248E-10 2.56106101870E-10 2.66557906977E-10 2.77436253198E-10 2.88758547689E-10 3.00542907984E-10 3.12808190987E-10 3.25574023147E-10 3.38860831856E-10 3.52689878143E-10 3.67083290686E-10 3.82064101226E-10 3.97656281415E-10 4.13884781176E-10 4.30775568624E-10 4.48355671616E-10 4.66653221001E-10 4.85697495628E-10 5.05518969194E-10 5.26149359007E-10 5.47621676736E-10 5.69970281228E-10 5.93230933489E-10 6.17440853898E-10 6.42638781767E-10 6.68865037326E-10 6.96161586233E-10 7.24572106722E-10 7.54142059495E-10 7.84918760455E-10 8.16951456416E-10 8.50291403899E-10 8.84991951145E-10 9.21108623470E-10 9.58699212112E-10 9.97823866694E-10 1.03854519146E-09 1.08092834546E-09 1.12504114679E-09 1.17095418108E-09 1.21874091449E-09 1.26847781120E-09 1.32024445577E-09 1.37412368048E-09 1.43020169786E-09 1.48856823862E-09 1.54931669520E-09 1.61254427125E-09 1.67835213709E-09 1.74684559162E-09 1.81813423075E-09 1.89233212281E-09 1.96955799099E-09 2.04993540333E-09 2.13359297038E-09 2.22066455103E-09 2.31128946661E-09 2.40561272382E-09 2.50378524672E-09 2.60596411820E-09 2.71231283129E-09 2.82300155074E-09 2.93820738524E-09 3.05811467078E-09 3.18291526560E-09 3.31280885706E-09 3.44800328117E-09 3.58871485510E-09 3.73516872318E-09 3.88759921719E-09 4.04625023117E-09 4.21137561163E-09 4.38323956368E-09 4.56211707367E-09 4.74829434910E-09 4.94206927655E-09 5.14375189816E-09 5.35366490766E-09 5.57214416658E-09 5.79953924157E-09 6.03621396359E-09 6.28254700993E-09 6.53893251001E-09 6.80578067585E-09 7.08351845831E-09 7.37259023003E-09 7.67345849631E-09 7.98660463497E-09 8.31252966635E-09 8.65175505479E-09 9.00482354278E-09 9.37230001909E-09 9.75477242245E-09 1.01528526819E-08 1.05671776958E-08 1.09984103503E-08 1.14472405800E-08 1.19143864711E-08 1.24005954106E-08 1.29066452811E-08 1.34333457055E-08 1.39815393417E-08 1.45521032305E-08 1.51459501983E-08 1.57640303175E-08 1.64073324255E-08 1.70768857063E-08 1.77737613373E-08 1.84990742014E-08 1.92539846711E-08 2.00397004637E-08 2.08574785729E-08 2.17086272793E-08 2.25945082429E-08 2.35165386800E-08 2.44761936305E-08 2.54750083163E-08 2.65145805967E-08 2.75965735234E-08 2.87227180005E-08 2.98948155517E-08 3.11147412018E-08 3.23844464749E-08 3.37059625147E-08 3.50814033328E-08 3.65129691889E-08 3.80029501091E-08 3.95537295474E-08 4.11677881969E-08 4.28477079564E-08 4.45961760583E-08 4.64159893652E-08 4.83100588420E-08 5.02814142096E-08 5.23332087889E-08 5.44687245425E-08 5.66913773214E-08 5.90047223260E-08 6.14124597896E-08 6.39184408942E-08 6.65266739265E-08 6.92413306858E-08 7.20667531528E-08 7.50074604302E-08 7.80681559664E-08 8.12537350740E-08 8.45692927538E-08 8.80201318394E-08 9.16117714724E-08 9.53499559236E-08 9.92406637740E-08 1.03290117470E-07 1.07504793267E-07 1.11891431582E-07 1.16457047761E-07 1.21208943295E-07 1.26154717484E-07 1.31302279582E-07 1.36659861435E-07 1.42236030635E-07 1.48039704208E-07 1.54080162864E-07 1.60367065823E-07 1.66910466247E-07 1.73720827304E-07 1.80809038879E-07 1.88186434977E-07 1.95864811823E-07 2.03856446707E-07 2.12174117600E-07 2.20831123555E-07 2.29841305957E-07 2.39219070627E-07 2.48979410829E-07 2.59137931216E-07 2.69710872751E-07 2.80715138641E-07 2.92168321331E-07 3.04088730594E-07 3.16495422768E-07 3.29408231179E-07 3.42847797813E-07 3.56835606263E-07 3.71394016032E-07 3.86546298225E-07 4.02316672696E-07 4.18730346705E-07 4.35813555158E-07 4.53593602473E-07 4.72098906158E-07 4.91359042164E-07 5.11404792077E-07 5.32268192240E-07 5.53982584868E-07 5.76582671245E-07 6.00104567088E-07 6.24585860162E-07 6.50065670239E-07 6.76584711502E-07 7.04185357478E-07 7.32911708628E-07 7.62809662671E-07 7.93926987777E-07 8.26313398740E-07 8.60020636247E-07 8.95102549362E-07 9.31615181384E-07 9.69616859177E-07 1.00916828615E-06 1.05033263899E-06 1.09317566839E-06 1.13776580377E-06 1.18417426237E-06 1.23247516269E-06 1.28274564258E-06 1.33506598214E-06 1.38951973156E-06 1.44619384425E-06 1.50517881526E-06 1.56656882545E-06 1.63046189138E-06 1.69696002146E-06 1.76616937823E-06 1.83820044744E-06 1.91316821388E-06 1.99119234432E-06 2.07239737802E-06 2.15691292480E-06 2.24487387129E-06 2.33642059549E-06 2.43169919001E-06 2.53086169446E-06 2.63406633715E-06 2.74147778673E-06 2.85326741390E-06 2.96961356387E-06 3.09070183973E-06 3.21672539747E-06 3.34788525278E-06 3.48439060047E-06 3.62645914671E-06 3.77431745478E-06 3.92820130484E-06 4.08835606823E-06 4.25503709704E-06 4.42851012933E-06 4.60905171083E-06 4.79694963371E-06 4.99250339315E-06 5.19602466228E-06 5.40783778647E-06 5.62828029757E-06 5.85770344891E-06 6.09647277203E-06 6.34496865586E-06 6.60358694936E-06 6.87273958849E-06 7.15285524856E-06 7.44438002293E-06 7.74777812910E-06 8.06353264340E-06 8.39214626528E-06 8.73414211251E-06 9.09006454845E-06 9.46048004273E-06 9.84597806671E-06 1.02471720249E-05 1.06647002243E-05 1.10992268823E-05 1.15514431757E-05 1.20220683318E-05 1.25118507635E-05 1.30215692499E-05 1.35520341652E-05 1.41040887557E-05 1.46786104699E-05 1.52765123406E-05 1.58987444237E-05 1.65462952942E-05 1.72201936027E-05 1.79215096940E-05 1.86513572918E-05 1.94108952495E-05 2.02013293727E-05 2.10239143141E-05 2.18799555445E-05 2.27708114035E-05 2.36978952313E-05 2.46626775868E-05 2.56666885548E-05 2.67115201443E-05 2.77988287845E-05 2.89303379194E-05 3.01078407070E-05 3.13332028256E-05 3.26083653937E-05 3.39353480046E-05 3.53162518841E-05 3.67532631731E-05 3.82486563413E-05 3.98047977375E-05 4.14241492813E-05 4.31092723013E-05 4.48628315270E-05 4.66875992392E-05 4.85864595851E-05 5.05624130661E-05 5.26185812026E-05 5.47582113849E-05 5.69846819167E-05 5.93015072583E-05 6.17123434776E-05 6.42209939179E-05 6.68314150890E-05 6.95477227924E-05 7.23741984882E-05 7.53152959138E-05 7.83756479640E-05 8.15600738429E-05 8.48735864972E-05 8.83214003432E-05 9.19089392978E-05 9.56418451256E-05 9.95259861138E-05 1.03567466089E-04 1.07772633786E-04 1.12148092588E-04 1.16700710644E-04 1.21437631383E-04 1.26366284446E-04 1.31494397034E-04 1.36830005710E-04 1.42381468658E-04 1.48157478412E-04 1.54167075097E-04 1.60419660166E-04 1.66925010690E-04 1.73693294186E-04 1.80735084029E-04 1.88061375463E-04 1.95683602222E-04 2.03613653804E-04 2.11863893404E-04 2.20447176542E-04 2.29376870408E-04 2.38666873951E-04 2.48331638738E-04 2.58386190614E-04 2.68846152193E-04 2.79727766208E-04 2.91047919752E-04 3.02824169447E-04 3.15074767563E-04 3.27818689145E-04 3.41075660152E-04 3.54866186680E-04 3.69211585274E-04 3.84134014400E-04 3.99656507094E-04 4.15803004842E-04 4.32598392737E-04 4.50068535952E-04 4.68240317572E-04 4.87141677853E-04 5.06801654932E-04 5.27250427057E-04 5.48519356387E-04 5.70641034408E-04 5.93649329035E-04 6.17579433446E-04 6.42467916714E-04 6.68352776300E-04 6.95273492461E-04 7.23271084655E-04 7.52388169990E-04 7.82669023804E-04 8.14159642435E-04 8.46907808260E-04 8.80963157075E-04 9.16377247899E-04 9.53203635269E-04 9.91497944124E-04 1.03131794734E-03 1.07272364605E-03 1.11577735270E-03 1.16054377721E-03 1.20709011595E-03 1.25548614398E-03 1.30580431042E-03 1.35811983716E-03 1.41251082095E-03 1.46905833905E-03 1.52784655844E-03 1.58896284877E-03 1.65249789915E-03 1.71854583888E-03 1.78720436224E-03 1.85857485742E-03 1.93276253976E-03 2.00987658941E-03 2.09003029343E-03 2.17334119270E-03 2.25993123338E-03 2.34992692347E-03 2.44345949423E-03 2.54066506684E-03 2.64168482425E-03 2.74666518854E-03 2.85575800365E-03 2.96912072392E-03 3.08691660828E-03 3.20931492042E-03 3.33649113496E-03 3.46862714982E-03 3.60591150480E-03 3.74853960662E-03 3.89671396044E-03 4.05064440810E-03 4.21054837294E-03 4.37665111171E-03 4.54918597324E-03 4.72839466427E-03 4.91452752247E-03 5.10784379658E-03 5.30861193403E-03 5.51710987584E-03 5.73362535902E-03 5.95845622650E-03 6.19191074457E-03 6.43430792798E-03 6.68597787255E-03 6.94726209545E-03 7.21851388306E-03 7.50009864640E-03 7.79239428402E-03 8.09579155244E-03 8.41069444386E-03 8.73752057116E-03 9.07670155999E-03 9.42868344785E-03 9.79392708983E-03 1.01729085710E-02 1.05661196251E-02 1.09740680588E-02 1.13972781824E-02 1.18362912451E-02 1.22916658754E-02 1.27639785259E-02 1.32538239221E-02 1.37618155147E-02 1.42885859337E-02 1.48347874462E-02 1.54010924139E-02 1.59881937519E-02 1.65968053877E-02 1.72276627173E-02 1.78815230612E-02 1.85591661148E-02 1.92613943959E-02 1.99890336854E-02 2.07429334613E-02 2.15239673235E-02 2.23330334092E-02 2.31710547951E-02 2.40389798871E-02 2.49377827937E-02 2.58684636819E-02 2.68320491131E-02 2.78295923568E-02 2.88621736803E-02 2.99309006104E-02 3.10369081654E-02 3.21813590549E-02 3.33654438426E-02 3.45903810707E-02 3.58574173415E-02 3.71678273533E-02 3.85229138854E-02 3.99240077301E-02 4.13724675663E-02 4.28696797705E-02 4.44170581616E-02 4.60160436725E-02 4.76681039464E-02 4.93747328505E-02 5.11374499019E-02 5.29577996015E-02 5.48373506680E-02 5.67776951672E-02 5.87804475306E-02 6.08472434557E-02 6.29797386812E-02 6.51796076318E-02 6.74485419239E-02 6.97882487245E-02 7.22004489579E-02 7.46868753497E-02 7.72492703026E-02 7.98893835943E-02 8.26089698899E-02 8.54097860608E-02 8.82935883009E-02 9.12621290320E-02 9.43171535901E-02 9.74603966834E-02 1.00693578614E-01 1.04018401255E-01 1.07436543771E-01 1.10949658083E-01 1.14559364054E-01 1.18267244409E-01 1.22074839355E-01 1.25983640922E-01 1.29995086992E-01 1.34110555033E-01 1.38331355511E-01 1.42658724994E-01 1.47093818925E-01 1.51637704079E-01 1.56291350685E-01 1.61055624223E-01 1.65931276887E-01 1.70918938723E-01 1.76019108433E-01 1.81232143864E-01 1.86558252171E-01 1.91997479670E-01 1.97549701392E-01 2.03214610344E-01 2.08991706484E-01 2.14880285448E-01 2.20879427018E-01 2.26987983373E-01 2.33204567143E-01 2.39527539278E-01 2.45954996791E-01 2.52484760372E-01 2.59114361944E-01 2.65841032179E-01 2.72661688028E-01 2.79572920307E-01 2.86570981404E-01 2.93651773149E-01 3.00810834915E-01 3.08043332021E-01 3.15344044492E-01 3.22707356267E-01 3.30127244929E-01 3.37597272032E-01 3.45110574126E-01 3.52659854570E-01 3.60237376221E-01 3.67834955115E-01 3.75443955240E-01 3.83055284499E-01 3.90659392002E-01 3.98246266778E-01 4.05805438039E-01 4.13325977117E-01 4.20796501194E-01 4.28205178949E-01 4.35539738254E-01 4.42787476032E-01 4.49935270408E-01 4.56969595275E-01 4.63876537389E-01 4.70641816104E-01 4.77250805867E-01 4.83688561557E-01 4.89939846781E-01 4.95989165194E-01 5.01820794920E-01 5.07418826146E-01 5.12767201913E-01 5.17849762157E-01 5.22650290991E-01 5.27152567235E-01 5.31340418161E-01 5.35197776396E-01 5.38708739916E-01 5.41857635019E-01 5.44629082151E-01 5.47008064421E-01 5.48979998614E-01 5.50530808482E-01 5.51647000040E-01 5.52315738594E-01 5.52524927161E-01 5.52263285911E-01 5.51520432251E-01 5.50286961098E-01 5.48554524879E-01 5.46315912747E-01 5.43565128492E-01 5.40297466555E-01 5.36509585574E-01 5.32199578820E-01 5.27367040895E-01 5.22013130018E-01 5.16140625231E-01 5.09753977841E-01 5.02859356404E-01 4.95464684575E-01 4.87579671143E-01 4.79215831598E-01 4.70386500591E-01 4.61106834689E-01 4.51393804860E-01 4.41266178175E-01 4.30744488275E-01 4.19850994199E-01 4.08609627265E-01 3.97045925764E-01 3.85186957316E-01 3.73061228848E-01 3.60698584228E-01 3.48130089738E-01 3.35387907658E-01 3.22505158343E-01 3.09515771341E-01 2.96454326176E-01 2.83355883569E-01 2.70255808005E-01 2.57189582649E-01 2.44192617764E-01 2.31300053877E-01 2.18546561052E-01 2.05966135755E-01 1.93591896838E-01 1.81455882309E-01 1.69588848577E-01 1.58020073962E-01 1.46777168252E-01 1.35885890185E-01 1.25369974687E-01 1.15250971731E-01 1.05548098664E-01 9.62781077834E-02 8.74551709404E-02 7.90907828209E-02 7.11936845074E-02 6.37698087897E-02 5.68222485659E-02 5.03512495220E-02 4.43542280965E-02 3.88258155356E-02 3.37579286150E-02 2.91398673441E-02 2.49584396880E-02 2.11981130210E-02 1.78411916824E-02 1.48680196271E-02 1.22572067567E-02 9.98587708419E-03 8.02993642440E-03 6.36435683185E-03 4.96347451523E-03 3.80129747351E-03 2.85181862006E-03 2.08932970965E-03 1.48873097337E-03 1.02583101746E-03 6.77631274439E-04 4.22589129921E-04 2.40853807876E-04 1.15307926665E-04 3.38518433065E-05 -1.36811187810E-05 -3.63626556865E-05 -4.20846107695E-05 -3.74903510648E-05 -2.79246250592E-05 -1.74041617080E-05 -8.61129796245E-06 -2.91294187366E-06 -4.07198224745E-07 5.00787383622E-18 -8.93658997777E-18 3.13493752453E-18 -1.25991656413E-17 -4.76547625031E-18 6.19812916198E-18 6.38865595848E-18 1.11763177442E-18 3.55030329554E-18 -2.54316121971E-18 -7.27174885131E-18 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 4 4 1 i j (l(j)) 3.73678604446E-01 Q_int 2.69493712668E-13 2.80491957220E-13 2.91939048492E-13 3.03853304257E-13 3.16253789849E-13 3.29160348673E-13 3.42593633958E-13 3.56575141806E-13 3.71127245593E-13 3.86273231766E-13 4.02037337110E-13 4.18444787533E-13 4.35521838427E-13 4.53295816691E-13 4.71795164449E-13 4.91049484575E-13 5.11089588053E-13 5.31947543288E-13 5.53656727420E-13 5.76251879735E-13 5.99769157253E-13 6.24246192589E-13 6.49722154174E-13 6.76237808929E-13 7.03835587504E-13 7.32559652173E-13 7.62455967506E-13 7.93572373920E-13 8.25958664233E-13 8.59666663346E-13 8.94750311168E-13 9.31265748939E-13 9.69271409058E-13 1.00882810860E-12 1.04999914661E-12 1.09285040544E-12 1.13745045613E-12 1.18387066816E-12 1.23218532363E-12 1.28247173617E-12 1.33481037463E-12 1.38928499184E-12 1.44598275864E-12 1.50499440339E-12 1.56641435712E-12 1.63034090468E-12 1.69687634197E-12 1.76612713966E-12 1.83820411357E-12 1.91322260199E-12 1.99130265025E-12 2.07256920280E-12 2.15715230317E-12 2.24518730204E-12 2.33681507388E-12 2.43218224230E-12 2.53144141474E-12 2.63475142666E-12 2.74227759570E-12 2.85419198621E-12 2.97067368461E-12 3.09190908598E-12 3.21809219227E-12 3.34942492281E-12 3.48611743737E-12 3.62838847250E-12 3.77646569152E-12 3.93058604884E-12 4.09099616915E-12 4.25795274204E-12 4.43172293277E-12 4.61258480980E-12 4.80082778973E-12 4.99675310046E-12 5.20067426317E-12 5.41291759404E-12 5.63382272646E-12 5.86374315442E-12 6.10304679825E-12 6.35211659336E-12 6.61135110296E-12 6.88116515588E-12 7.16199051040E-12 7.45427654508E-12 7.75849097792E-12 8.07512061478E-12 8.40467212835E-12 8.74767286894E-12 9.10467170836E-12 9.47623991819E-12 9.86297208395E-12 1.02654870565E-11 1.06844289425E-11 1.11204681348E-11 1.15743023855E-11 1.20466579223E-11 1.25382906107E-11 1.30499871635E-11 1.35825663997E-11 1.41368805547E-11 1.47138166441E-11 1.53142978832E-11 1.59392851642E-11 1.65897785937E-11 1.72668190932E-11 1.79714900650E-11 1.87049191253E-11 1.94682799091E-11 2.02627939480E-11 2.10897326250E-11 2.19504192087E-11 2.28462309711E-11 2.37786013913E-11 2.47490224494E-11 2.57590470140E-11 2.68102913268E-11 2.79044375893E-11 2.90432366543E-11 3.02285108278E-11 3.14621567848E-11 3.27461486047E-11 3.40825409295E-11 3.54734722525E-11 3.69211683396E-11 3.84279457912E-11 3.99962157489E-11 4.16284877543E-11 4.33273737642E-11 4.50955923303E-11 4.69359729497E-11 4.88514605920E-11 5.08451204124E-11 5.29201426558E-11 5.50798477625E-11 5.73276916809E-11 5.96672713977E-11 6.21023306940E-11 6.46367661356E-11 6.72746333085E-11 7.00201533082E-11 7.28777194944E-11 7.58519045209E-11 7.89474676529E-11 8.21693623823E-11 8.55227443540E-11 8.90129796165E-11 9.26456532074E-11 9.64265780911E-11 1.00361804460E-10 1.04457629417E-10 1.08720607049E-10 1.13157558918E-10 1.17775584974E-10 1.22582074917E-10 1.27584720023E-10 1.32791525447E-10 1.38210823038E-10 1.43851284666E-10 1.49721936104E-10 1.55832171463E-10 1.62191768232E-10 1.68810902917E-10 1.75700167328E-10 1.82870585528E-10 1.90333631471E-10 1.98101247360E-10 2.06185862764E-10 2.14600414498E-10 2.23358367328E-10 2.32473735517E-10 2.41961105247E-10 2.51835657960E-10 2.62113194651E-10 2.72810161152E-10 2.83943674444E-10 2.95531550049E-10 3.07592330537E-10 3.20145315195E-10 3.33210590909E-10 3.46809064305E-10 3.60962495201E-10 3.75693531426E-10 3.91025745060E-10 4.06983670148E-10 4.23592841962E-10 4.40879837856E-10 4.58872319794E-10 4.77599078610E-10 4.97090080081E-10 5.17376512868E-10 5.38490838426E-10 5.60466842940E-10 5.83339691392E-10 6.07145983823E-10 6.31923813896E-10 6.57712829852E-10 6.84554297945E-10 7.12491168477E-10 7.41568144514E-10 7.71831753422E-10 8.03330421304E-10 8.36114550493E-10 8.70236600193E-10 9.05751170420E-10 9.42715089360E-10 9.81187504302E-10 1.02122997627E-09 1.06290657853E-09 1.10628399909E-09 1.15143164745E-09 1.19842176560E-09 1.24732954363E-09 1.29823324006E-09 1.35121430704E-09 1.40635752064E-09 1.46375111655E-09 1.52348693120E-09 1.58566054877E-09 1.65037145404E-09 1.71772319161E-09 1.78782353159E-09 1.86078464197E-09 1.93672326815E-09 2.01576091969E-09 2.09802406470E-09 2.18364433226E-09 2.27275872294E-09 2.36550982804E-09 2.46204605771E-09 2.56252187841E-09 2.66709806003E-09 2.77594193312E-09 2.88922765659E-09 3.00713649639E-09 3.12985711547E-09 3.25758587563E-09 3.39052715173E-09 3.52889365860E-09 3.67290679138E-09 3.82279697976E-09 3.97880405658E-09 4.14117764158E-09 4.31017754071E-09 4.48607416184E-09 4.66914894728E-09 4.85969482414E-09 5.05801667289E-09 5.26443181514E-09 5.47927052130E-09 5.70287653894E-09 5.93560764269E-09 6.17783620666E-09 6.42994980009E-09 6.69235180741E-09 6.96546207356E-09 7.24971757560E-09 7.54557312180E-09 7.85350207918E-09 8.17399713079E-09 8.50757106384E-09 8.85475759001E-09 9.21611219922E-09 9.59221304825E-09 9.98366188557E-09 1.03910850140E-08 1.08151342924E-08 1.12564881786E-08 1.17158528147E-08 1.21939631564E-08 1.26915841487E-08 1.32095119498E-08 1.37485752040E-08 1.43096363678E-08 1.48935930892E-08 1.55013796432E-08 1.61339684268E-08 1.67923715139E-08 1.74776422741E-08 1.81908770578E-08 1.89332169498E-08 1.97058495939E-08 2.05100110931E-08 2.13469879861E-08 2.22181193055E-08 2.31247987190E-08 2.40684767584E-08 2.50506631399E-08 2.60729291782E-08 2.71369102999E-08 2.82443086585E-08 2.93968958573E-08 3.05965157820E-08 3.18450875501E-08 3.31446085795E-08 3.44971577829E-08 3.59048988927E-08 3.73700839204E-08 3.88950567588E-08 4.04822569294E-08 4.21342234838E-08 4.38535990636E-08 4.56431341264E-08 4.75056913435E-08 4.94442501776E-08 5.14619116466E-08 5.35619032822E-08 5.57475842904E-08 5.80224509224E-08 6.03901420650E-08 6.28544450581E-08 6.54193017503E-08 6.80888148011E-08 7.08672542399E-08 7.37590642926E-08 7.67688704867E-08 7.99014870461E-08 8.31619245870E-08 8.65553981278E-08 9.00873354264E-08 9.37633856557E-08 9.75894284348E-08 1.01571583226E-07 1.05716219120E-07 1.10029965009E-07 1.14519720190E-07 1.19192665389E-07 1.24056274236E-07 1.29118325211E-07 1.34386914078E-07 1.39870466820E-07 1.45577753106E-07 1.51517900307E-07 1.57700408079E-07 1.64135163547E-07 1.70832457101E-07 1.77802998842E-07 1.85057935692E-07 1.92608869207E-07 2.00467874114E-07 2.08647517600E-07 2.17160879394E-07 2.26021572661E-07 2.35243765750E-07 2.44842204828E-07 2.54832237437E-07 2.65229837011E-07 2.76051628388E-07 2.87314914368E-07 2.99037703345E-07 3.11238738077E-07 3.23937525610E-07 3.37154368441E-07 3.50910396933E-07 3.65227603064E-07 3.80128875541E-07 3.95638036349E-07 4.11779878789E-07 4.28580207062E-07 4.46065877469E-07 4.64264841283E-07 4.83206189376E-07 5.02920198654E-07 5.23438380387E-07 5.44793530508E-07 5.67019781958E-07 5.90152659161E-07 6.14229134722E-07 6.39287688423E-07 6.65368368635E-07 6.92512856217E-07 7.20764531021E-07 7.50168541103E-07 7.80771874754E-07 8.12623435458E-07 8.45774119901E-07 8.80276899156E-07 9.16186903171E-07 9.53561508697E-07 9.92460430783E-07 1.03294581801E-06 1.07508235158E-06 1.11893734845E-06 1.16458086866E-06 1.21208582702E-06 1.26152810933E-06 1.31298669336E-06 1.36654377470E-06 1.42228489778E-06 1.48029909216E-06 1.54067901444E-06 1.60352109581E-06 1.66892569577E-06 1.73699726194E-06 1.80784449645E-06 1.88158052907E-06 1.95832309736E-06 2.03819473421E-06 2.12132296286E-06 2.20784049998E-06 2.29788546695E-06 2.39160160969E-06 2.48913852744E-06 2.59065191086E-06 2.69630378973E-06 2.80626279079E-06 2.92070440597E-06 3.03981127156E-06 3.16377345866E-06 3.29278877548E-06 3.42706308184E-06 3.56681061650E-06 3.71225433767E-06 3.86362627746E-06 4.02116791057E-06 4.18513053803E-06 4.35577568648E-06 4.53337552356E-06 4.71821329025E-06 4.91058375068E-06 5.11079366012E-06 5.31916225203E-06 5.53602174475E-06 5.76171786879E-06 5.99661041537E-06 6.24107380734E-06 6.49549769300E-06 6.76028756414E-06 7.03586539901E-06 7.32267033129E-06 7.62115934618E-06 7.93180800463E-06 8.25511119682E-06 8.59158392616E-06 8.94176212496E-06 9.30620350310E-06 9.68548843091E-06 1.00802208579E-05 1.04910292682E-05 1.09185676754E-05 1.13635166566E-05 1.18265844286E-05 1.23085079679E-05 1.28100541754E-05 1.33320210882E-05 1.38752391403E-05 1.44405724744E-05 1.50289203061E-05 1.56412183432E-05 1.62784402629E-05 1.69415992471E-05 1.76317495813E-05 1.83499883158E-05 1.90974569960E-05 1.98753434605E-05 2.06848837122E-05 2.15273638654E-05 2.24041221695E-05 2.33165511157E-05 2.42660996275E-05 2.52542753388E-05 2.62826469649E-05 2.73528467667E-05 2.84665731158E-05 2.96255931608E-05 3.08317456013E-05 3.20869435734E-05 3.33931776499E-05 3.47525189616E-05 3.61671224425E-05 3.76392302062E-05 3.91711750559E-05 4.07653841363E-05 4.24243827298E-05 4.41507982057E-05 4.59473641267E-05 4.78169245189E-05 4.97624383124E-05 5.17869839595E-05 5.38937642363E-05 5.60861112357E-05 5.83674915595E-05 6.07415117169E-05 6.32119237379E-05 6.57826310096E-05 6.84576943447E-05 7.12413382910E-05 7.41379576910E-05 7.71521245019E-05 8.02885948858E-05 8.35523165815E-05 8.69484365670E-05 9.04823090260E-05 9.41595036293E-05 9.79858141434E-05 1.01967267379E-04 1.06110132492E-04 1.10420930653E-04 1.14906445096E-04 1.19573731564E-04 1.24430129164E-04 1.29483271652E-04 1.34741099155E-04 1.40211870363E-04 1.45904175188E-04 1.51826947928E-04 1.57989480943E-04 1.64401438862E-04 1.71072873354E-04 1.78014238465E-04 1.85236406567E-04 1.92750684912E-04 2.00568832845E-04 2.08703079679E-04 2.17166143264E-04 2.25971249281E-04 2.35132151282E-04 2.44663151501E-04 2.54579122481E-04 2.64895529526E-04 2.75628454026E-04 2.86794617674E-04 2.98411407627E-04 3.10496902621E-04 3.23069900097E-04 3.36149944365E-04 3.49757355845E-04 3.63913261429E-04 3.78639625999E-04 3.93959285148E-04 4.09895979149E-04 4.26474388207E-04 4.43720169064E-04 4.61659992971E-04 4.80321585112E-04 4.99733765513E-04 5.19926491483E-04 5.40930901670E-04 5.62779361753E-04 5.85505511859E-04 6.09144315751E-04 6.33732111847E-04 6.59306666150E-04 6.85907227139E-04 7.13574582696E-04 7.42351119147E-04 7.72280882479E-04 8.03409641815E-04 8.35784955219E-04 8.69456237923E-04 9.04474833042E-04 9.40894084872E-04 9.78769414860E-04 1.01815840032E-03 1.05912085603E-03 1.10171891870E-03 1.14601713460E-03 1.19208255019E-03 1.23998480613E-03 1.28979623453E-03 1.34159195971E-03 1.39545000254E-03 1.45145138843E-03 1.50968025910E-03 1.57022398838E-03 1.63317330185E-03 1.69862240088E-03 1.76666909075E-03 1.83741491333E-03 1.91096528425E-03 1.98742963478E-03 2.06692155852E-03 2.14955896312E-03 2.23546422699E-03 2.32476436142E-03 2.41759117797E-03 2.51408146152E-03 2.61437714893E-03 2.71862551369E-03 2.82697935647E-03 2.93959720190E-03 3.05664350172E-03 3.17828884437E-03 3.30471017126E-03 3.43609099992E-03 3.57262165406E-03 3.71449950082E-03 3.86192919535E-03 4.01512293287E-03 4.17430070832E-03 4.33969058392E-03 4.51152896458E-03 4.69006088153E-03 4.87554028419E-03 5.06823034046E-03 5.26840374563E-03 5.47634303996E-03 5.69234093521E-03 5.91670065006E-03 6.14973625475E-03 6.39177302490E-03 6.64314780471E-03 6.90420937962E-03 7.17531885844E-03 7.45685006523E-03 7.74918994071E-03 8.05273895355E-03 8.36791152129E-03 8.69513644115E-03 9.03485733059E-03 9.38753307758E-03 9.75363830066E-03 1.01336638186E-02 1.05281171297E-02 1.09375229002E-02 1.13624234625E-02 1.18033793222E-02 1.22609696735E-02 1.27357929244E-02 1.32284672290E-02 1.37396310284E-02 1.42699435990E-02 1.48200856082E-02 1.53907596763E-02 1.59826909449E-02 1.65966276504E-02 1.72333417028E-02 1.78936292682E-02 1.85783113545E-02 1.92882344002E-02 2.00242708634E-02 2.07873198123E-02 2.15783075143E-02 2.23981880234E-02 2.32479437636E-02 2.41285861086E-02 2.50411559537E-02 2.59867242813E-02 2.69663927150E-02 2.79812940627E-02 2.90325928462E-02 3.01214858138E-02 3.12492024354E-02 3.24170053760E-02 3.36261909463E-02 3.48780895259E-02 3.61740659582E-02 3.75155199118E-02 3.89038862060E-02 4.03406350969E-02 4.18272725198E-02 4.33653402843E-02 4.49564162173E-02 4.66021142505E-02 4.83040844463E-02 5.00640129585E-02 5.18836219215E-02 5.37646692631E-02 5.57089484359E-02 5.77182880594E-02 5.97945514683E-02 6.19396361606E-02 6.41554731364E-02 6.64440261238E-02 6.88072906813E-02 7.12472931707E-02 7.37660895934E-02 7.63657642789E-02 7.90484284205E-02 8.18162184471E-02 8.46712942227E-02 8.76158370646E-02 9.06520475702E-02 9.37821432429E-02 9.70083559072E-02 1.00332928902E-01 1.03758114043E-01 1.07286168340E-01 1.10919350467E-01 1.14659916960E-01 1.18510118146E-01 1.22472193782E-01 1.26548368399E-01 1.30740846338E-01 1.35051806461E-01 1.39483396539E-01 1.44037727298E-01 1.48716866102E-01 1.53522830295E-01 1.58457580151E-01 1.63523011458E-01 1.68720947704E-01 1.74053131871E-01 1.79521217817E-01 1.85126761260E-01 1.90871210326E-01 1.96755895698E-01 2.02782020319E-01 2.08950648689E-01 2.15262695718E-01 2.21718915170E-01 2.28319887672E-01 2.35066008314E-01 2.41957473840E-01 2.48994269436E-01 2.56176155136E-01 2.63502651849E-01 2.70973027041E-01 2.78586280075E-01 2.86341127249E-01 2.94235986554E-01 3.02268962177E-01 3.10437828798E-01 3.18740015713E-01 3.27172590823E-01 3.35732244557E-01 3.44415273754E-01 3.53217565592E-01 3.62134581607E-01 3.71161341887E-01 3.80292409502E-01 3.89521875264E-01 3.98843342898E-01 4.08249914710E-01 4.17734177865E-01 4.27288191370E-01 4.36903473872E-01 4.46570992397E-01 4.56281152138E-01 4.66023787434E-01 4.75788154071E-01 4.85562923029E-01 4.95336175847E-01 5.05095401728E-01 5.14827496550E-01 5.24518763938E-01 5.34154918552E-01 5.43721091755E-01 5.53201839822E-01 5.62581154850E-01 5.71842478539E-01 5.80968718989E-01 5.89942270692E-01 5.98745037841E-01 6.07358461134E-01 6.15763548186E-01 6.23940907697E-01 6.31870787476E-01 6.39533116446E-01 6.46907550699E-01 6.53973523697E-01 6.60710300642E-01 6.67097037083E-01 6.73112841738E-01 6.78736843525E-01 6.83948262753E-01 6.88726486403E-01 6.93051147370E-01 6.96902207536E-01 7.00260044479E-01 7.03105541603E-01 7.05420181411E-01 7.07186141625E-01 7.08386393787E-01 7.09004803952E-01 7.09026235015E-01 7.08436650187E-01 7.07223217078E-01 7.05374411793E-01 7.02880122406E-01 6.99731751144E-01 6.95922314545E-01 6.91446540844E-01 6.86300963765E-01 6.80484011918E-01 6.73996092920E-01 6.66839671363E-01 6.59019339741E-01 6.50541881417E-01 6.41416324737E-01 6.31653987367E-01 6.21268509997E-01 6.10275878529E-01 5.98694433933E-01 5.86544869009E-01 5.73850211303E-01 5.60635791571E-01 5.46929197181E-01 5.32760210012E-01 5.18160728451E-01 5.03164673253E-01 4.87807877118E-01 4.72127957998E-01 4.56164176286E-01 4.39957276184E-01 4.23549311722E-01 4.06983458055E-01 3.90303808835E-01 3.73555160643E-01 3.56782785608E-01 3.40032193553E-01 3.23348885135E-01 3.06778097633E-01 2.90364545191E-01 2.74152155453E-01 2.58183804672E-01 2.42501053490E-01 2.27143885683E-01 2.12150452246E-01 1.97556823268E-01 1.83396750071E-01 1.69701440114E-01 1.56499347158E-01 1.43815979143E-01 1.31673726185E-01 1.20091710996E-01 1.09085663927E-01 9.86678246854E-02 8.88468725984E-02 7.96278870974E-02 7.10123398565E-02 6.29981197520E-02 5.55795915112E-02 4.87476885866E-02 4.24900404235E-02 3.67911338938E-02 3.16325082344E-02 2.69929823647E-02 2.28489129622E-02 1.91744811516E-02 1.59420051126E-02 1.31222753466E-02 1.06849087607E-02 8.59871714892E-03 6.83208508057E-03 5.35335166461E-03 4.13119016078E-03 3.13497897938E-03 2.33515727250E-03 1.70355809818E-03 1.21371206371E-03 8.41114452965E-04 5.63449144533E-04 3.60763157615E-04 2.16181041202E-04 1.17306097642E-04 5.37050104737E-05 1.62563850017E-05 -2.81452314736E-06 -9.92581879412E-06 -1.01553670000E-05 -7.28497267226E-06 -3.87342836360E-06 -1.35917091749E-06 -1.92891885734E-07 5.13697571070E-18 -1.67029023410E-18 4.73795246417E-18 3.34899081658E-18 -2.57074878708E-18 8.54010402474E-20 -2.61303388094E-19 1.07528687446E-18 7.01835101327E-19 3.49204766836E-19 -2.10664881341E-18 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2S 0 2.00 Wavefunction 5.59955522176E-04 5.65583167942E-04 5.71267372464E-04 5.77008704166E-04 5.82807737186E-04 5.88665051430E-04 5.94581232633E-04 6.00556872418E-04 6.06592568353E-04 6.12688924010E-04 6.18846549030E-04 6.25066059178E-04 6.31348076410E-04 6.37693228931E-04 6.44102151261E-04 6.50575484295E-04 6.57113875371E-04 6.63717978333E-04 6.70388453593E-04 6.77125968204E-04 6.83931195921E-04 6.90804817272E-04 6.97747519621E-04 7.04759997244E-04 7.11842951392E-04 7.18997090364E-04 7.26223129579E-04 7.33521791644E-04 7.40893806430E-04 7.48339911142E-04 7.55860850395E-04 7.63457376286E-04 7.71130248473E-04 7.78880234245E-04 7.86708108607E-04 7.94614654349E-04 8.02600662130E-04 8.10666930555E-04 8.18814266254E-04 8.27043483964E-04 8.35355406613E-04 8.43750865395E-04 8.52230699861E-04 8.60795757997E-04 8.69446896314E-04 8.78184979928E-04 8.87010882653E-04 8.95925487082E-04 9.04929684678E-04 9.14024375867E-04 9.23210470119E-04 9.32488886049E-04 9.41860551501E-04 9.51326403646E-04 9.60887389071E-04 9.70544463879E-04 9.80298593781E-04 9.90150754192E-04 1.00010193033E-03 1.01015311732E-03 1.02030532028E-03 1.03055955444E-03 1.04091684521E-03 1.05137822834E-03 1.06194474996E-03 1.07261746674E-03 1.08339744593E-03 1.09428576554E-03 1.10528351441E-03 1.11639179232E-03 1.12761171009E-03 1.13894438972E-03 1.15039096447E-03 1.16195257901E-03 1.17363038950E-03 1.18542556371E-03 1.19733928118E-03 1.20937273327E-03 1.22152712333E-03 1.23380366680E-03 1.24620359133E-03 1.25872813691E-03 1.27137855601E-03 1.28415611366E-03 1.29706208761E-03 1.31009776847E-03 1.32326445980E-03 1.33656347826E-03 1.34999615377E-03 1.36356382958E-03 1.37726786247E-03 1.39110962282E-03 1.40509049482E-03 1.41921187655E-03 1.43347518015E-03 1.44788183194E-03 1.46243327258E-03 1.47713095721E-03 1.49197635560E-03 1.50697095228E-03 1.52211624671E-03 1.53741375340E-03 1.55286500211E-03 1.56847153796E-03 1.58423492158E-03 1.60015672931E-03 1.61623855332E-03 1.63248200179E-03 1.64888869905E-03 1.66546028576E-03 1.68219841907E-03 1.69910477278E-03 1.71618103752E-03 1.73342892089E-03 1.75085014769E-03 1.76844646000E-03 1.78621961746E-03 1.80417139737E-03 1.82230359487E-03 1.84061802319E-03 1.85911651373E-03 1.87780091635E-03 1.89667309944E-03 1.91573495023E-03 1.93498837486E-03 1.95443529866E-03 1.97407766629E-03 1.99391744198E-03 2.01395660967E-03 2.03419717326E-03 2.05464115677E-03 2.07529060458E-03 2.09614758159E-03 2.11721417348E-03 2.13849248688E-03 2.15998464957E-03 2.18169281075E-03 2.20361914119E-03 2.22576583349E-03 2.24813510228E-03 2.27072918444E-03 2.29355033934E-03 2.31660084906E-03 2.33988301859E-03 2.36339917610E-03 2.38715167317E-03 2.41114288499E-03 2.43537521063E-03 2.45985107327E-03 2.48457292043E-03 2.50954322424E-03 2.53476448167E-03 2.56023921478E-03 2.58596997098E-03 2.61195932327E-03 2.63820987052E-03 2.66472423771E-03 2.69150507620E-03 2.71855506399E-03 2.74587690599E-03 2.77347333432E-03 2.80134710852E-03 2.82950101587E-03 2.85793787168E-03 2.88666051953E-03 2.91567183159E-03 2.94497470887E-03 2.97457208156E-03 3.00446690929E-03 3.03466218141E-03 3.06516091734E-03 3.09596616682E-03 3.12708101025E-03 3.15850855898E-03 3.19025195562E-03 3.22231437438E-03 3.25469902135E-03 3.28740913483E-03 3.32044798568E-03 3.35381887762E-03 3.38752514758E-03 3.42157016600E-03 3.45595733720E-03 3.49069009972E-03 3.52577192663E-03 3.56120632593E-03 3.59699684084E-03 3.63314705020E-03 3.66966056881E-03 3.70654104780E-03 3.74379217497E-03 3.78141767521E-03 3.81942131080E-03 3.85780688185E-03 3.89657822665E-03 3.93573922206E-03 3.97529378389E-03 4.01524586731E-03 4.05559946721E-03 4.09635861863E-03 4.13752739718E-03 4.17910991939E-03 4.22111034317E-03 4.26353286820E-03 4.30638173636E-03 4.34966123217E-03 4.39337568317E-03 4.43752946040E-03 4.48212697882E-03 4.52717269776E-03 4.57267112132E-03 4.61862679891E-03 4.66504432559E-03 4.71192834265E-03 4.75928353797E-03 4.80711464654E-03 4.85542645094E-03 4.90422378178E-03 4.95351151824E-03 5.00329458848E-03 5.05357797020E-03 5.10436669110E-03 5.15566582941E-03 5.20748051437E-03 5.25981592674E-03 5.31267729935E-03 5.36606991761E-03 5.41999912000E-03 5.47447029867E-03 5.52948889992E-03 5.58506042476E-03 5.64119042950E-03 5.69788452623E-03 5.75514838345E-03 5.81298772659E-03 5.87140833862E-03 5.93041606058E-03 5.99001679220E-03 6.05021649249E-03 6.11102118030E-03 6.17243693497E-03 6.23446989689E-03 6.29712626814E-03 6.36041231310E-03 6.42433435910E-03 6.48889879700E-03 6.55411208186E-03 6.61998073361E-03 6.68651133765E-03 6.75371054552E-03 6.82158507560E-03 6.89014171374E-03 6.95938731395E-03 7.02932879908E-03 7.09997316152E-03 7.17132746391E-03 7.24339883980E-03 7.31619449440E-03 7.38972170529E-03 7.46398782316E-03 7.53900027249E-03 7.61476655235E-03 7.69129423713E-03 7.76859097729E-03 7.84666450010E-03 7.92552261047E-03 8.00517319167E-03 8.08562420614E-03 8.16688369628E-03 8.24895978528E-03 8.33186067786E-03 8.41559466117E-03 8.50017010556E-03 8.58559546544E-03 8.67187928009E-03 8.75903017458E-03 8.84705686055E-03 8.93596813711E-03 9.02577289176E-03 9.11648010118E-03 9.20809883222E-03 9.30063824275E-03 9.39410758258E-03 9.48851619439E-03 9.58387351466E-03 9.68018907459E-03 9.77747250108E-03 9.87573351767E-03 9.97498194551E-03 1.00752277043E-02 1.01764808135E-02 1.02787513928E-02 1.03820496638E-02 1.04863859505E-02 1.05917706806E-02 1.06982143864E-02 1.08057277061E-02 1.09143213844E-02 1.10240062741E-02 1.11347933366E-02 1.12466936436E-02 1.13597183778E-02 1.14738788340E-02 1.15891864206E-02 1.17056526602E-02 1.18232891911E-02 1.19421077686E-02 1.20621202655E-02 1.21833386742E-02 1.23057751071E-02 1.24294417983E-02 1.25543511043E-02 1.26805155060E-02 1.28079476093E-02 1.29366601464E-02 1.30666659774E-02 1.31979780914E-02 1.33306096076E-02 1.34645737770E-02 1.35998839832E-02 1.37365537444E-02 1.38745967139E-02 1.40140266824E-02 1.41548575785E-02 1.42971034705E-02 1.44407785680E-02 1.45858972228E-02 1.47324739307E-02 1.48805233328E-02 1.50300602169E-02 1.51810995191E-02 1.53336563251E-02 1.54877458720E-02 1.56433835493E-02 1.58005849010E-02 1.59593656267E-02 1.61197415834E-02 1.62817287869E-02 1.64453434135E-02 1.66106018016E-02 1.67775204532E-02 1.69461160356E-02 1.71164053830E-02 1.72884054984E-02 1.74621335549E-02 1.76376068977E-02 1.78148430454E-02 1.79938596924E-02 1.81746747099E-02 1.83573061484E-02 1.85417722386E-02 1.87280913942E-02 1.89162822127E-02 1.91063634782E-02 1.92983541623E-02 1.94922734269E-02 1.96881406251E-02 1.98859753042E-02 2.00857972065E-02 2.02876262721E-02 2.04914826404E-02 2.06973866523E-02 2.09053588519E-02 2.11154199890E-02 2.13275910206E-02 2.15418931133E-02 2.17583476452E-02 2.19769762081E-02 2.21978006097E-02 2.24208428752E-02 2.26461252503E-02 2.28736702027E-02 2.31035004244E-02 2.33356388343E-02 2.35701085800E-02 2.38069330402E-02 2.40461358271E-02 2.42877407883E-02 2.45317720099E-02 2.47782538178E-02 2.50272107810E-02 2.52786677135E-02 2.55326496767E-02 2.57891819820E-02 2.60482901933E-02 2.63100001292E-02 2.65743378657E-02 2.68413297387E-02 2.71110023466E-02 2.73833825527E-02 2.76584974879E-02 2.79363745533E-02 2.82170414230E-02 2.85005260464E-02 2.87868566513E-02 2.90760617461E-02 2.93681701233E-02 2.96632108615E-02 2.99612133286E-02 3.02622071845E-02 3.05662223840E-02 3.08732891796E-02 3.11834381244E-02 3.14967000751E-02 3.18131061948E-02 3.21326879561E-02 3.24554771441E-02 3.27815058592E-02 3.31108065204E-02 3.34434118684E-02 3.37793549685E-02 3.41186692137E-02 3.44613883282E-02 3.48075463702E-02 3.51571777355E-02 3.55103171603E-02 3.58669997248E-02 3.62272608564E-02 3.65911363329E-02 3.69586622862E-02 3.73298752052E-02 3.77048119397E-02 3.80835097035E-02 3.84660060779E-02 3.88523390153E-02 3.92425468430E-02 3.96366682660E-02 4.00347423713E-02 4.04368086313E-02 4.08429069073E-02 4.12530774533E-02 4.16673609198E-02 4.20857983573E-02 4.25084312203E-02 4.29353013708E-02 4.33664510826E-02 4.38019230445E-02 4.42417603650E-02 4.46860065754E-02 4.51347056343E-02 4.55879019313E-02 4.60456402912E-02 4.65079659779E-02 4.69749246984E-02 4.74465626072E-02 4.79229263101E-02 4.84040628686E-02 4.88900198037E-02 4.93808451009E-02 4.98765872134E-02 5.03772950675E-02 5.08830180658E-02 5.13938060924E-02 5.19097095170E-02 5.24307791990E-02 5.29570664924E-02 5.34886232500E-02 5.40255018278E-02 5.45677550898E-02 5.51154364124E-02 5.56685996889E-02 5.62272993341E-02 5.67915902893E-02 5.73615280262E-02 5.79371685526E-02 5.85185684161E-02 5.91057847097E-02 5.96988750758E-02 6.02978977117E-02 6.09029113739E-02 6.15139753834E-02 6.21311496300E-02 6.27544945778E-02 6.33840712696E-02 6.40199413323E-02 6.46621669815E-02 6.53108110268E-02 6.59659368766E-02 6.66276085431E-02 6.72958906476E-02 6.79708484255E-02 6.86525477310E-02 6.93410550429E-02 7.00364374692E-02 7.07387627525E-02 7.14480992750E-02 7.21645160638E-02 7.28880827962E-02 7.36188698045E-02 7.43569480819E-02 7.51023892869E-02 7.58552657493E-02 7.66156504749E-02 7.73836171511E-02 7.81592401520E-02 7.89425945437E-02 7.97337560898E-02 8.05328012560E-02 8.13398072163E-02 8.21548518577E-02 8.29780137853E-02 8.38093723283E-02 8.46490075444E-02 8.54970002258E-02 8.63534319039E-02 8.72183848549E-02 8.80919421048E-02 8.89741874347E-02 8.98652053859E-02 9.07650812652E-02 9.16739011499E-02 9.25917518931E-02 9.35187211285E-02 9.44548972757E-02 9.54003695453E-02 9.63552279435E-02 9.73195632776E-02 9.82934671603E-02 9.92770320150E-02 1.00270351081E-01 1.01273518416E-01 1.02286628905E-01 1.03309778261E-01 1.04343063031E-01 1.05386580602E-01 1.06440429202E-01 1.07504707908E-01 1.08579516648E-01 1.09664956206E-01 1.10761128227E-01 1.11868135219E-01 1.12986080558E-01 1.14115068492E-01 1.15255204146E-01 1.16406593522E-01 1.17569343506E-01 1.18743561869E-01 1.19929357272E-01 1.21126839270E-01 1.22336118309E-01 1.23557305738E-01 1.24790513802E-01 1.26035855654E-01 1.27293445349E-01 1.28563397850E-01 1.29845829032E-01 1.31140855680E-01 1.32448595489E-01 1.33769167074E-01 1.35102689960E-01 1.36449284591E-01 1.37809072328E-01 1.39182175447E-01 1.40568717144E-01 1.41968821531E-01 1.43382613636E-01 1.44810219404E-01 1.46251765697E-01 1.47707380287E-01 1.49177191860E-01 1.50661330014E-01 1.52159925251E-01 1.53673108982E-01 1.55201013517E-01 1.56743772066E-01 1.58301518735E-01 1.59874388518E-01 1.61462517295E-01 1.63066041829E-01 1.64685099755E-01 1.66319829579E-01 1.67970370668E-01 1.69636863245E-01 1.71319448378E-01 1.73018267976E-01 1.74733464779E-01 1.76465182346E-01 1.78213565049E-01 1.79978758057E-01 1.81760907332E-01 1.83560159610E-01 1.85376662391E-01 1.87210563928E-01 1.89062013209E-01 1.90931159945E-01 1.92818154551E-01 1.94723148132E-01 1.96646292467E-01 1.98587739985E-01 2.00547643754E-01 2.02526157451E-01 2.04523435351E-01 2.06539632296E-01 2.08574903678E-01 2.10629405413E-01 2.12703293914E-01 2.14796726066E-01 2.16909859199E-01 2.19042851058E-01 2.21195859771E-01 2.23369043825E-01 2.25562562023E-01 2.27776573458E-01 2.30011237473E-01 2.32266713628E-01 2.34543161658E-01 2.36840741434E-01 2.39159612924E-01 2.41499936144E-01 2.43861871122E-01 2.46245577842E-01 2.48651216203E-01 2.51078945965E-01 2.53528926697E-01 2.56001317727E-01 2.58496278079E-01 2.61013966422E-01 2.63554541005E-01 2.66118159599E-01 2.68704979426E-01 2.71315157099E-01 2.73948848551E-01 2.76606208958E-01 2.79287392674E-01 2.81992553145E-01 2.84721842837E-01 2.87475413151E-01 2.90253414336E-01 2.93055995406E-01 2.95883304045E-01 2.98735486515E-01 3.01612687562E-01 3.04515050310E-01 3.07442716164E-01 3.10395824699E-01 3.13374513553E-01 3.16378918311E-01 3.19409172389E-01 3.22465406915E-01 3.25547750600E-01 3.28656329614E-01 3.31791267451E-01 3.34952684792E-01 3.38140699365E-01 3.41355425799E-01 3.44596975478E-01 3.47865456380E-01 3.51160972926E-01 3.54483625811E-01 3.57833511836E-01 3.61210723740E-01 3.64615350015E-01 3.68047474726E-01 3.71507177324E-01 3.74994532446E-01 3.78509609722E-01 3.82052473562E-01 3.85623182954E-01 3.89221791239E-01 3.92848345890E-01 3.96502888287E-01 4.00185453476E-01 4.03896069927E-01 4.07634759292E-01 4.11401536141E-01 4.15196407708E-01 4.19019373616E-01 4.22870425607E-01 4.26749547252E-01 4.30656713668E-01 4.34591891216E-01 4.38555037196E-01 4.42546099535E-01 4.46565016468E-01 4.50611716206E-01 4.54686116602E-01 4.58788124808E-01 4.62917636917E-01 4.67074537606E-01 4.71258699768E-01 4.75469984128E-01 4.79708238862E-01 4.83973299198E-01 4.88264987016E-01 4.92583110430E-01 4.96927463370E-01 5.01297825148E-01 5.05693960020E-01 5.10115616739E-01 5.14562528091E-01 5.19034410433E-01 5.23530963215E-01 5.28051868491E-01 5.32596790431E-01 5.37165374810E-01 5.41757248497E-01 5.46372018937E-01 5.51009273613E-01 5.55668579511E-01 5.60349482568E-01 5.65051507114E-01 5.69774155311E-01 5.74516906570E-01 5.79279216973E-01 5.84060518684E-01 5.88860219344E-01 5.93677701469E-01 5.98512321837E-01 6.03363410864E-01 6.08230271979E-01 6.13112180990E-01 6.18008385447E-01 6.22918103994E-01 6.27840525721E-01 6.32774809511E-01 6.37720083384E-01 6.42675443831E-01 6.47639955157E-01 6.52612648814E-01 6.57592522735E-01 6.62578540666E-01 6.67569631506E-01 6.72564688639E-01 6.77562569273E-01 6.82562093787E-01 6.87562045075E-01 6.92561167898E-01 6.97558168251E-01 7.02551712725E-01 7.07540427893E-01 7.12522899695E-01 7.17497672848E-01 7.22463250258E-01 7.27418092462E-01 7.32360617077E-01 7.37289198273E-01 7.42202166274E-01 7.47097806872E-01 7.51974360979E-01 7.56830024197E-01 7.61662946433E-01 7.66471231532E-01 7.71252936958E-01 7.76006073512E-01 7.80728605089E-01 7.85418448481E-01 7.90073473232E-01 7.94691501539E-01 7.99270308211E-01 8.03807620690E-01 8.08301119123E-01 8.12748436512E-01 8.17147158924E-01 8.21494825780E-01 8.25788930223E-01 8.30026919556E-01 8.34206195785E-01 8.38324116232E-01 8.42377994261E-01 8.46365100090E-01 8.50282661717E-01 8.54127865948E-01 8.57897859542E-01 8.61589750480E-01 8.65200609346E-01 8.68727470852E-01 8.72167335486E-01 8.75517171303E-01 8.78773915865E-01 8.81934478326E-01 8.84995741673E-01 8.87954565132E-01 8.90807786730E-01 8.93552226039E-01 8.96184687087E-01 8.98701961453E-01 9.01100831548E-01 9.03378074080E-01 9.05530463715E-01 9.07554776943E-01 9.09447796130E-01 9.11206313788E-01 9.12827137043E-01 9.14307092316E-01 9.15643030219E-01 9.16831830654E-01 9.17870408135E-01 9.18755717317E-01 9.19484758742E-01 9.20054584792E-01 9.20462305851E-01 9.20705096678E-01 9.20780202971E-01 9.20684948133E-01 9.20416740224E-01 9.19973079091E-01 9.19351563668E-01 9.18549899441E-01 9.17565906048E-01 9.16397525023E-01 9.15042827640E-01 9.13500022872E-01 9.11767465407E-01 9.09843663732E-01 9.07727288235E-01 9.05417179317E-01 9.02912355468E-01 9.00212021281E-01 8.97315575374E-01 8.94222618169E-01 8.90932959501E-01 8.87446625998E-01 8.83763868196E-01 8.79885167329E-01 8.75811241749E-01 8.71543052902E-01 8.67081810820E-01 8.62428979047E-01 8.57586278929E-01 8.52555693213E-01 8.47339468860E-01 8.41940119000E-01 8.36360423947E-01 8.30603431183E-01 8.24672454225E-01 8.18571070276E-01 8.12303116572E-01 8.05872685318E-01 7.99284117114E-01 7.92541992771E-01 7.85651123404E-01 7.78616538709E-01 7.71443473299E-01 7.64137351012E-01 7.56703767065E-01 7.49148467968E-01 7.41477329080E-01 7.33696329724E-01 7.25811525744E-01 7.17829019447E-01 7.09754926813E-01 7.01595341929E-01 6.93356298561E-01 6.85043728829E-01 6.76663418935E-01 6.68220961916E-01 6.59721707433E-01 6.51170708590E-01 6.42572665821E-01 6.33931867908E-01 6.25252130210E-01 6.16536730213E-01 6.07788340547E-01 5.99008959654E-01 5.90199840311E-01 5.81362197903E-01 5.72499783654E-01 5.63617027955E-01 5.54718327804E-01 5.45808043691E-01 5.36890496544E-01 5.27969964724E-01 5.19050681089E-01 5.10136830111E-01 5.01232545058E-01 4.92339009427E-01 4.83463108623E-01 4.74608805221E-01 4.65779999902E-01 4.56980528971E-01 4.48214161950E-01 4.39484599249E-01 4.30795469909E-01 4.22150329426E-01 4.13552657651E-01 4.05005856776E-01 3.96513249396E-01 3.88078076662E-01 3.79703496508E-01 3.71392581976E-01 3.63148319617E-01 3.54973607992E-01 3.46871256249E-01 3.38843982804E-01 3.30894414101E-01 3.23025083477E-01 3.15238430106E-01 3.07536798053E-01 2.99922435409E-01 2.92397493530E-01 2.84964026370E-01 2.77623989912E-01 2.70379241693E-01 2.63231540433E-01 2.56182545757E-01 2.49233818017E-01 2.42386818216E-01 2.35642908025E-01 2.29003349907E-01 2.22469307328E-01 2.16041845084E-01 2.09721929704E-01 2.03510429974E-01 1.97408117540E-01 1.91415667618E-01 1.85533659794E-01 1.79762578925E-01 1.74102816128E-01 1.68554669863E-01 1.63118347110E-01 1.57793964630E-01 1.52581550323E-01 1.47481044659E-01 1.42492302210E-01 1.37615093246E-01 1.32849105426E-01 1.28193945559E-01 1.23649141440E-01 1.19214143761E-01 1.14888328088E-01 1.10670996910E-01 1.06561381746E-01 1.02558645314E-01 9.86618837571E-02 9.48701289228E-02 9.11823506922E-02 8.75974593546E-02 8.41143080246E-02 8.07316950978E-02 7.74483667401E-02 7.42630194078E-02 7.11743023936E-02 6.81808203941E-02 6.52811360952E-02 6.24737727710E-02 5.97572168913E-02 5.71299207336E-02 5.45903049959E-02 5.21367614046E-02 4.97676553149E-02 4.74813282974E-02 4.52761007084E-02 4.31502742386E-02 4.11021344361E-02 3.91299532004E-02 3.72319912425E-02 3.54065005071E-02 3.36517265539E-02 3.19659108943E-02 3.03472932783E-02 2.87941139301E-02 2.73046157286E-02 2.58770463290E-02 2.45096602227E-02 2.32007207335E-02 2.19485019466E-02 2.07512905687E-02 1.96073877159E-02 1.85151106285E-02 1.74727943105E-02 1.64787930917E-02 1.55314821116E-02 1.46292587236E-02 1.37705438187E-02 1.29537830677E-02 1.21774480813E-02 1.14400374888E-02 1.07400779330E-02 1.00761249843E-02 9.44676397193E-03 8.85061073399E-03 8.28631228699E-03 7.75254741526E-03 7.24802718184E-03 6.77149536198E-03 6.32172880057E-03 5.89753769539E-03 5.49776580777E-03 5.12129060264E-03 4.76702332019E-03 4.43390898118E-03 4.12092632830E-03 3.82708770609E-03 3.55143888191E-03 3.29305881053E-03 3.05105934526E-03 2.82458489812E-03 2.61281205214E-03 2.41494912852E-03 2.23023571161E-03 2.05794213458E-03 1.89736892888E-03 1.74784624024E-03 1.60873321423E-03 1.47941735435E-03 1.35931385535E-03 1.24786491489E-03 1.14453902596E-03 1.04883025322E-03 9.60257495523E-04 8.78363737473E-04 8.02715292466E-04 7.32901039564E-04 6.68531656635E-04 6.09238851931E-04 5.54674596266E-04 5.04510357822E-04 4.58436341480E-04 4.16160734526E-04 3.77408960378E-04 3.41922941965E-04 3.09460376178E-04 2.79794020778E-04 2.52710994968E-04 2.28012094774E-04 2.05511124208E-04 1.85034243144E-04 1.66419332662E-04 1.49515378545E-04 1.34181873520E-04 1.20288238689E-04 1.07713264546E-04 9.63445718572E-05 8.60780926016E-05 7.68175710782E-05 6.84740852183E-05 6.09655880536E-05 5.42164692300E-05 4.81571363872E-05 4.27236161653E-05 3.78571745446E-05 3.35039561739E-05 2.96146422986E-05 2.61441268561E-05 2.30512102749E-05 2.02983104778E-05 1.78511905650E-05 1.56787026319E-05 1.37525471540E-05 1.20470473606E-05 1.05389380062E-05 9.20716794193E-06 8.03271588577E-06 6.99841878855E-06 6.08881219580E-06 5.28998200975E-06 4.58942706287E-06 3.97593192365E-06 3.43944936667E-06 2.97099195167E-06 2.56253217107E-06 2.20691064075E-06 1.89775528679E-06 1.62943145863E-06 1.39690418837E-06 1.19570787923E-06 1.02189143040E-06 8.71964483114E-07 7.42848610976E-07 6.31833076157E-07 5.36534793576E-07 4.54862166137E-07 3.84982474098E-07 3.25292521342E-07 2.74392260403E-07 2.31061136563E-07 1.94236909147E-07 1.62996725206E-07 1.36540237175E-07 1.14174571702E-07 9.53009716690E-08 7.94029475491E-08 6.60357875168E-08 5.48172882988E-08 4.54195805245E-08 3.75619333847E-08 3.10044337232E-08 2.55424442965E-08 2.10017548661E-08 1.72343480583E-08 1.41147095696E-08 1.15366193354E-08 9.41036674923E-09 7.66033894901E-09 6.22293660380E-09 5.04477657526E-09 4.08114531744E-09 3.29467095091E-09 2.65418563136E-09 2.13375315596E-09 1.71183974394E-09 1.37060861579E-09 1.09532140643E-09 8.73831606109E-10 6.96157154102E-10 5.54121038685E-10 4.41050305882E-10 3.50230625663E-10 2.77454891690E-10 2.19276753445E-10 1.72879820162E-10 1.35968082443E-10 1.06674338020E-10 8.34838556302E-11 6.51709025325E-11 5.07461028801E-11 3.94128913831E-11 3.05315845620E-11 2.35898149024E-11 1.81782655444E-11 1.39708085070E-11 1.07082912073E-11 8.18533720297E-12 6.23963033643E-12 4.74323918215E-12 3.59561299760E-12 2.71794311998E-12 2.04863656834E-12 1.53969293700E-12 1.15381275104E-12 8.62096383581E-13 6.42218348992E-13 4.76983096924E-13 3.53186037128E-13 2.60718022241E-13 1.91863414884E-13 1.40751600418E-13 1.02929745026E-13 7.50310505467E-14 5.45179836884E-14 3.94841764343E-14 2.85020891311E-14 2.05062497964E-14 1.47040583086E-14 1.05078762649E-14 7.48349780502E-15 5.31118359716E-15 3.75629660580E-15 2.64725066183E-15 1.85900887782E-15 1.30077896074E-15 9.06870888396E-16 6.29928780946E-16 4.35938708279E-16 3.00560013665E-16 2.06439306298E-16 1.41251305211E-16 9.62752688453E-17 6.53645593096E-17 4.42036597506E-17 2.97745498256E-17 1.99749586334E-17 1.33463567114E-17 8.88092071766E-18 5.88509903210E-18 3.88357760054E-18 2.55196292110E-18 1.66979224487E-18 1.08787147216E-18 7.05668902959E-19 4.55736275801E-19 2.93019309375E-19 1.87555370660E-19 1.19507124807E-19 7.58000215681E-20 4.78559683824E-20 3.00728055358E-20 1.88088588475E-20 1.17079541827E-20 7.25285243278E-21 4.47120841668E-21 2.74288757280E-21 1.67431312016E-21 1.01692583448E-21 6.14531196958E-22 3.69469465149E-22 2.20989081825E-22 1.31491655612E-22 7.78283665563E-23 4.58212560950E-23 2.68325651844E-23 1.56278799404E-23 9.05225784604E-24 5.21445364314E-24 2.98697493842E-24 1.70137796753E-24 9.63588986781E-25 5.42599938215E-25 3.03766154227E-25 1.69061744134E-25 9.35345281470E-26 5.14390929750E-26 2.81179197415E-26 1.52761940331E-26 8.24826347121E-27 4.42586620887E-27 2.35990859067E-27 1.25033300947E-27 6.58206283892E-28 3.44251688598E-28 1.78870819210E-28 9.23259156683E-29 4.73368683347E-29 2.41067111556E-29 1.21929677183E-29 6.12468957740E-30 3.05514493649E-30 1.51329016593E-30 7.44259743375E-31 3.63419091167E-31 1.76173461712E-31 8.47795515561E-32 4.04974461392E-32 1.92007303561E-32 9.03501386193E-33 4.21917854249E-33 1.95515729547E-33 8.98993596567E-34 4.10127254102E-34 1.85623730988E-34 8.33425058611E-35 3.71178494637E-35 1.63963396941E-35 7.18328598051E-36 3.12086868130E-36 1.34452071997E-36 5.74331163347E-37 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2P 1 4.00 Wavefunction 1.83154562923E-07 1.86854530186E-07 1.90629241731E-07 1.94480207493E-07 1.98408967909E-07 2.02417094535E-07 2.06506190673E-07 2.10677892015E-07 2.14933867297E-07 2.19275818965E-07 2.23705483855E-07 2.28224633892E-07 2.32835076795E-07 2.37538656801E-07 2.42337255404E-07 2.47232792105E-07 2.52227225184E-07 2.57322552478E-07 2.62520812185E-07 2.67824083676E-07 2.73234488330E-07 2.78754190377E-07 2.84385397772E-07 2.90130363070E-07 2.95991384332E-07 3.01970806043E-07 3.08071020048E-07 3.14294466513E-07 3.20643634896E-07 3.27121064948E-07 3.33729347725E-07 3.40471126625E-07 3.47349098446E-07 3.54366014467E-07 3.61524681544E-07 3.68827963237E-07 3.76278780953E-07 3.83880115114E-07 3.91635006353E-07 3.99546556725E-07 4.07617930954E-07 4.15852357691E-07 4.24253130814E-07 4.32823610739E-07 4.41567225770E-07 4.50487473463E-07 4.59587922032E-07 4.68872211772E-07 4.78344056519E-07 4.88007245132E-07 4.97865643009E-07 5.07923193634E-07 5.18183920157E-07 5.28651926998E-07 5.39331401494E-07 5.50226615570E-07 5.61341927449E-07 5.72681783397E-07 5.84250719501E-07 5.96053363481E-07 6.08094436544E-07 6.20378755271E-07 6.32911233544E-07 6.45696884513E-07 6.58740822598E-07 6.72048265540E-07 6.85624536481E-07 6.99475066101E-07 7.13605394784E-07 7.28021174839E-07 7.42728172757E-07 7.57732271522E-07 7.73039472959E-07 7.88655900140E-07 8.04587799828E-07 8.20841544981E-07 8.37423637299E-07 8.54340709823E-07 8.71599529590E-07 8.89207000342E-07 9.07170165283E-07 9.25496209899E-07 9.44192464832E-07 9.63266408814E-07 9.82725671655E-07 1.00257803730E-06 1.02283144693E-06 1.04349400215E-06 1.06457396825E-06 1.08607977746E-06 1.10802003237E-06 1.13040350933E-06 1.15323916202E-06 1.17653612496E-06 1.20030371722E-06 1.22455144612E-06 1.24928901104E-06 1.27452630730E-06 1.30027343012E-06 1.32654067864E-06 1.35333856008E-06 1.38067779391E-06 1.40856931614E-06 1.43702428371E-06 1.46605407892E-06 1.49567031405E-06 1.52588483592E-06 1.55670973069E-06 1.58815732868E-06 1.62024020929E-06 1.65297120603E-06 1.68636341167E-06 1.72043018349E-06 1.75518514857E-06 1.79064220929E-06 1.82681554887E-06 1.86371963706E-06 1.90136923590E-06 1.93977940565E-06 1.97896551080E-06 2.01894322622E-06 2.05972854344E-06 2.10133777704E-06 2.14378757116E-06 2.18709490617E-06 2.23127710548E-06 2.27635184243E-06 2.32233714741E-06 2.36925141503E-06 2.41711341149E-06 2.46594228208E-06 2.51575755887E-06 2.56657916849E-06 2.61842744010E-06 2.67132311354E-06 2.72528734763E-06 2.78034172861E-06 2.83650827878E-06 2.89380946532E-06 2.95226820928E-06 3.01190789474E-06 3.07275237815E-06 3.13482599790E-06 3.19815358404E-06 3.26276046821E-06 3.32867249377E-06 3.39591602617E-06 3.46451796343E-06 3.53450574698E-06 3.60590737257E-06 3.67875140150E-06 3.75306697204E-06 3.82888381108E-06 3.90623224604E-06 3.98514321695E-06 4.06564828889E-06 4.14777966459E-06 4.23157019729E-06 4.31705340390E-06 4.40426347841E-06 4.49323530557E-06 4.58400447483E-06 4.67660729458E-06 4.77108080666E-06 4.86746280123E-06 4.96579183181E-06 5.06610723076E-06 5.16844912497E-06 5.27285845195E-06 5.37937697618E-06 5.48804730582E-06 5.59891290975E-06 5.71201813496E-06 5.82740822429E-06 5.94512933454E-06 6.06522855490E-06 6.18775392579E-06 6.31275445813E-06 6.44028015286E-06 6.57038202100E-06 6.70311210402E-06 6.83852349471E-06 6.97667035832E-06 7.11760795432E-06 7.26139265845E-06 7.40808198529E-06 7.55773461126E-06 7.71041039807E-06 7.86617041669E-06 8.02507697179E-06 8.18719362659E-06 8.35258522838E-06 8.52131793439E-06 8.69345923825E-06 8.86907799705E-06 9.04824445879E-06 9.23103029055E-06 9.41750860713E-06 9.60775400029E-06 9.80184256857E-06 9.99985194777E-06 1.02018613420E-05 1.04079515552E-05 1.06182050238E-05 1.08327058493E-05 1.10515398322E-05 1.12747945061E-05 1.15025591731E-05 1.17349249388E-05 1.19719847496E-05 1.22138334292E-05 1.24605677168E-05 1.27122863058E-05 1.29690898834E-05 1.32310811703E-05 1.34983649626E-05 1.37710481732E-05 1.40492398745E-05 1.43330513424E-05 1.46225961005E-05 1.49179899656E-05 1.52193510940E-05 1.55268000288E-05 1.58404597481E-05 1.61604557142E-05 1.64869159236E-05 1.68199709585E-05 1.71597540388E-05 1.75064010754E-05 1.78600507247E-05 1.82208444438E-05 1.85889265474E-05 1.89644442651E-05 1.93475478007E-05 1.97383903921E-05 2.01371283725E-05 2.05439212331E-05 2.09589316864E-05 2.13823257323E-05 2.18142727231E-05 2.22549454326E-05 2.27045201242E-05 2.31631766217E-05 2.36310983816E-05 2.41084725657E-05 2.45954901167E-05 2.50923458339E-05 2.55992384519E-05 2.61163707190E-05 2.66439494795E-05 2.71821857552E-05 2.77312948309E-05 2.82914963395E-05 2.88630143507E-05 2.94460774599E-05 3.00409188801E-05 3.06477765348E-05 3.12668931534E-05 3.18985163682E-05 3.25428988132E-05 3.32002982256E-05 3.38709775482E-05 3.45552050351E-05 3.52532543588E-05 3.59654047196E-05 3.66919409569E-05 3.74331536640E-05 3.81893393031E-05 3.89608003248E-05 3.97478452887E-05 4.05507889866E-05 4.13699525686E-05 4.22056636713E-05 4.30582565490E-05 4.39280722073E-05 4.48154585393E-05 4.57207704647E-05 4.66443700721E-05 4.75866267631E-05 4.85479174003E-05 4.95286264584E-05 5.05291461771E-05 5.15498767184E-05 5.25912263265E-05 5.36536114912E-05 5.47374571138E-05 5.58431966776E-05 5.69712724209E-05 5.81221355138E-05 5.92962462385E-05 6.04940741735E-05 6.17160983810E-05 6.29628075989E-05 6.42347004354E-05 6.55322855690E-05 6.68560819515E-05 6.82066190155E-05 6.95844368860E-05 7.09900865962E-05 7.24241303080E-05 7.38871415363E-05 7.53797053786E-05 7.69024187485E-05 7.84558906148E-05 8.00407422440E-05 8.16576074495E-05 8.33071328443E-05 8.49899780997E-05 8.67068162088E-05 8.84583337554E-05 9.02452311885E-05 9.20682231021E-05 9.39280385207E-05 9.58254211909E-05 9.77611298780E-05 9.97359386698E-05 1.01750637286E-04 1.03806031392E-04 1.05902942923E-04 1.08042210413E-04 1.10224689325E-04 1.12451252400E-04 1.14722789998E-04 1.17040210460E-04 1.19404440467E-04 1.21816425413E-04 1.24277129780E-04 1.26787537524E-04 1.29348652469E-04 1.31961498707E-04 1.34627121007E-04 1.37346585236E-04 1.40120978775E-04 1.42951410966E-04 1.45839013545E-04 1.48784941098E-04 1.51790371523E-04 1.54856506497E-04 1.57984571960E-04 1.61175818601E-04 1.64431522359E-04 1.67752984931E-04 1.71141534295E-04 1.74598525237E-04 1.78125339893E-04 1.81723388299E-04 1.85394108958E-04 1.89138969410E-04 1.92959466819E-04 1.96857128574E-04 2.00833512891E-04 2.04890209442E-04 2.09028839988E-04 2.13251059022E-04 2.17558554434E-04 2.21953048182E-04 2.26436296981E-04 2.31010093001E-04 2.35676264585E-04 2.40436676975E-04 2.45293233060E-04 2.50247874132E-04 2.55302580662E-04 2.60459373088E-04 2.65720312625E-04 2.71087502080E-04 2.76563086698E-04 2.82149255013E-04 2.87848239719E-04 2.93662318568E-04 2.99593815268E-04 3.05645100416E-04 3.11818592442E-04 3.18116758570E-04 3.24542115805E-04 3.31097231934E-04 3.37784726549E-04 3.44607272091E-04 3.51567594918E-04 3.58668476386E-04 3.65912753959E-04 3.73303322342E-04 3.80843134629E-04 3.88535203483E-04 3.96382602336E-04 4.04388466608E-04 4.12555994961E-04 4.20888450570E-04 4.29389162421E-04 4.38061526638E-04 4.46909007833E-04 4.55935140487E-04 4.65143530354E-04 4.74537855896E-04 4.84121869750E-04 4.93899400215E-04 5.03874352777E-04 5.14050711666E-04 5.24432541435E-04 5.35023988578E-04 5.45829283178E-04 5.56852740592E-04 5.68098763160E-04 5.79571841959E-04 5.91276558587E-04 6.03217586982E-04 6.15399695278E-04 6.27827747701E-04 6.40506706501E-04 6.53441633919E-04 6.66637694200E-04 6.80100155641E-04 6.93834392683E-04 7.07845888044E-04 7.22140234894E-04 7.36723139072E-04 7.51600421351E-04 7.66778019747E-04 7.82261991870E-04 7.98058517331E-04 8.14173900184E-04 8.30614571430E-04 8.47387091563E-04 8.64498153167E-04 8.81954583569E-04 8.99763347542E-04 9.17931550060E-04 9.36466439112E-04 9.55375408571E-04 9.74666001116E-04 9.94345911218E-04 1.01442298818E-03 1.03490523925E-03 1.05580083277E-03 1.07711810141E-03 1.09886554546E-03 1.12105183621E-03 1.14368581932E-03 1.16677651837E-03 1.19033313839E-03 1.21436506949E-03 1.23888189057E-03 1.26389337311E-03 1.28940948501E-03 1.31544039449E-03 1.34199647416E-03 1.36908830506E-03 1.39672668082E-03 1.42492261193E-03 1.45368733007E-03 1.48303229252E-03 1.51296918668E-03 1.54350993461E-03 1.57466669781E-03 1.60645188191E-03 1.63887814158E-03 1.67195838548E-03 1.70570578134E-03 1.74013376113E-03 1.77525602630E-03 1.81108655315E-03 1.84763959834E-03 1.88492970442E-03 1.92297170556E-03 1.96178073336E-03 2.00137222270E-03 2.04176191786E-03 2.08296587861E-03 2.12500048649E-03 2.16788245121E-03 2.21162881719E-03 2.25625697015E-03 2.30178464393E-03 2.34822992737E-03 2.39561127138E-03 2.44394749606E-03 2.49325779809E-03 2.54356175813E-03 2.59487934843E-03 2.64723094062E-03 2.70063731356E-03 2.75511966143E-03 2.81069960191E-03 2.86739918457E-03 2.92524089939E-03 2.98424768543E-03 3.04444293973E-03 3.10585052632E-03 3.16849478540E-03 3.23240054278E-03 3.29759311936E-03 3.36409834095E-03 3.43194254815E-03 3.50115260647E-03 3.57175591669E-03 3.64378042529E-03 3.71725463522E-03 3.79220761680E-03 3.86866901881E-03 3.94666907984E-03 4.02623863984E-03 4.10740915186E-03 4.19021269407E-03 4.27468198192E-03 4.36085038061E-03 4.44875191774E-03 4.53842129628E-03 4.62989390762E-03 4.72320584506E-03 4.81839391741E-03 4.91549566289E-03 5.01454936332E-03 5.11559405851E-03 5.21866956096E-03 5.32381647084E-03 5.43107619120E-03 5.54049094348E-03 5.65210378335E-03 5.76595861677E-03 5.88210021639E-03 6.00057423823E-03 6.12142723868E-03 6.24470669176E-03 6.37046100678E-03 6.49873954624E-03 6.62959264408E-03 6.76307162428E-03 6.89922881974E-03 7.03811759158E-03 7.17979234867E-03 7.32430856763E-03 7.47172281310E-03 7.62209275839E-03 7.77547720651E-03 7.93193611154E-03 8.09153060042E-03 8.25432299504E-03 8.42037683484E-03 8.58975689964E-03 8.76252923301E-03 8.93876116595E-03 9.11852134102E-03 9.30187973684E-03 9.48890769308E-03 9.67967793577E-03 9.87426460314E-03 1.00727432718E-02 1.02751909833E-02 1.04816862716E-02 1.06923091902E-02 1.09071413402E-02 1.11262658990E-02 1.13497676490E-02 1.15777330071E-02 1.18102500545E-02 1.20474085670E-02 1.22893000458E-02 1.25360177490E-02 1.27876567230E-02 1.30443138353E-02 1.33060878067E-02 1.35730792450E-02 1.38453906787E-02 1.41231265911E-02 1.44063934552E-02 1.46952997692E-02 1.49899560921E-02 1.52904750803E-02 1.55969715240E-02 1.59095623851E-02 1.62283668352E-02 1.65535062933E-02 1.68851044658E-02 1.72232873853E-02 1.75681834509E-02 1.79199234688E-02 1.82786406934E-02 1.86444708689E-02 1.90175522716E-02 1.93980257525E-02 1.97860347805E-02 2.01817254864E-02 2.05852467068E-02 2.09967500292E-02 2.14163898372E-02 2.18443233563E-02 2.22807107003E-02 2.27257149182E-02 2.31795020410E-02 2.36422411302E-02 2.41141043255E-02 2.45952668939E-02 2.50859072787E-02 2.55862071488E-02 2.60963514496E-02 2.66165284523E-02 2.71469298059E-02 2.76877505875E-02 2.82391893545E-02 2.88014481963E-02 2.93747327865E-02 2.99592524358E-02 3.05552201445E-02 3.11628526558E-02 3.17823705092E-02 3.24139980941E-02 3.30579637032E-02 3.37144995870E-02 3.43838420072E-02 3.50662312911E-02 3.57619118858E-02 3.64711324119E-02 3.71941457182E-02 3.79312089353E-02 3.86825835295E-02 3.94485353567E-02 4.02293347156E-02 4.10252564013E-02 4.18365797577E-02 4.26635887304E-02 4.35065719182E-02 4.43658226253E-02 4.52416389112E-02 4.61343236420E-02 4.70441845389E-02 4.79715342275E-02 4.89166902853E-02 4.98799752883E-02 5.08617168571E-02 5.18622477007E-02 5.28819056603E-02 5.39210337507E-02 5.49799802010E-02 5.60590984927E-02 5.71587473971E-02 5.82792910103E-02 5.94210987862E-02 6.05845455673E-02 6.17700116139E-02 6.29778826298E-02 6.42085497863E-02 6.54624097431E-02 6.67398646663E-02 6.80413222434E-02 6.93671956950E-02 7.07179037832E-02 7.20938708158E-02 7.34955266475E-02 7.49233066764E-02 7.63776518362E-02 7.78590085843E-02 7.93678288849E-02 8.09045701872E-02 8.24696953979E-02 8.40636728487E-02 8.56869762579E-02 8.73400846857E-02 8.90234824833E-02 9.07376592351E-02 9.24831096941E-02 9.42603337098E-02 9.60698361485E-02 9.79121268055E-02 9.97877203092E-02 1.01697136016E-01 1.03640897895E-01 1.05619534406E-01 1.07633578367E-01 1.09683566805E-01 1.11770040808E-01 1.13893545352E-01 1.16054629127E-01 1.18253844348E-01 1.20491746547E-01 1.22768894361E-01 1.25085849299E-01 1.27443175501E-01 1.29841439476E-01 1.32281209828E-01 1.34763056965E-01 1.37287552792E-01 1.39855270386E-01 1.42466783655E-01 1.45122666975E-01 1.47823494812E-01 1.50569841318E-01 1.53362279917E-01 1.56201382856E-01 1.59087720750E-01 1.62021862085E-01 1.65004372720E-01 1.68035815345E-01 1.71116748926E-01 1.74247728119E-01 1.77429302662E-01 1.80662016736E-01 1.83946408297E-01 1.87283008387E-01 1.90672340403E-01 1.94114919347E-01 1.97611251041E-01 2.01161831304E-01 2.04767145107E-01 2.08427665686E-01 2.12143853624E-01 2.15916155896E-01 2.19745004880E-01 2.23630817329E-01 2.27573993309E-01 2.31574915094E-01 2.35633946023E-01 2.39751429321E-01 2.43927686878E-01 2.48163017979E-01 2.52457698008E-01 2.56811977094E-01 2.61226078726E-01 2.65700198314E-01 2.70234501718E-01 2.74829123722E-01 2.79484166473E-01 2.84199697868E-01 2.88975749900E-01 2.93812316959E-01 2.98709354085E-01 3.03666775187E-01 3.08684451198E-01 3.13762208208E-01 3.18899825539E-01 3.24097033779E-01 3.29353512783E-01 3.34668889619E-01 3.40042736485E-01 3.45474568582E-01 3.50963841950E-01 3.56509951272E-01 3.62112227638E-01 3.67769936284E-01 3.73482274293E-01 3.79248368282E-01 3.85067272052E-01 3.90937964225E-01 3.96859345862E-01 4.02830238068E-01 4.08849379585E-01 4.14915424385E-01 4.21026939258E-01 4.27182401409E-01 4.33380196061E-01 4.39618614082E-01 4.45895849628E-01 4.52209997819E-01 4.58559052453E-01 4.64940903766E-01 4.71353336240E-01 4.77794026484E-01 4.84260541172E-01 4.90750335080E-01 4.97260749198E-01 5.03789008960E-01 5.10332222577E-01 5.16887379502E-01 5.23451349042E-01 5.30020879104E-01 5.36592595133E-01 5.43162999206E-01 5.49728469347E-01 5.56285259036E-01 5.62829496960E-01 5.69357187000E-01 5.75864208490E-01 5.82346316757E-01 5.88799143954E-01 5.95218200222E-01 6.01598875187E-01 6.07936439815E-01 6.14226048650E-01 6.20462742453E-01 6.26641451255E-01 6.32756997864E-01 6.38804101824E-01 6.44777383871E-01 6.50671370881E-01 6.56480501356E-01 6.62199131457E-01 6.67821541595E-01 6.73341943617E-01 6.78754488597E-01 6.84053275247E-01 6.89232358966E-01 6.94285761552E-01 6.99207481569E-01 7.03991505402E-01 7.08631819002E-01 7.13122420318E-01 7.17457332438E-01 7.21630617422E-01 7.25636390845E-01 7.29468837022E-01 7.33122224921E-01 7.36590924746E-01 7.39869425164E-01 7.42952351161E-01 7.45834482487E-01 7.48510772664E-01 7.50976368495E-01 7.53226630054E-01 7.55257151058E-01 7.57063779596E-01 7.58642639105E-01 7.59990149530E-01 7.61103048567E-01 7.61978412880E-01 7.62613679183E-01 7.63006665058E-01 7.63155589371E-01 7.63059092136E-01 7.62716253664E-01 7.62126612824E-01 7.61290184225E-01 7.60207474121E-01 7.58879494821E-01 7.57307777383E-01 7.55494382348E-01 7.53441908255E-01 7.51153497686E-01 7.48632840549E-01 7.45884174324E-01 7.42912280958E-01 7.39722480124E-01 7.36320618501E-01 7.32713054781E-01 7.28906640062E-01 7.24908693300E-01 7.20726971505E-01 7.16369634349E-01 7.11845202867E-01 7.07162511959E-01 7.02330656389E-01 6.97358930011E-01 6.92256757979E-01 6.87033621720E-01 6.81698976469E-01 6.76262161254E-01 6.70732301200E-01 6.65118202137E-01 6.59428237514E-01 6.53670227723E-01 6.47851311999E-01 6.41977813148E-01 6.36055095472E-01 6.30087416327E-01 6.24077771925E-01 6.18027738042E-01 6.11937306503E-01 6.05805572345E-01 5.99633801980E-01 5.93423959454E-01 5.87178012004E-01 5.80897929204E-01 5.74585682119E-01 5.68243242473E-01 5.61872581830E-01 5.55475670791E-01 5.49054478193E-01 5.42610970333E-01 5.36147110189E-01 5.29664856662E-01 5.23166163826E-01 5.16652980182E-01 5.10127247931E-01 5.03590902245E-01 4.97045870557E-01 4.90494071848E-01 4.83937415952E-01 4.77377802859E-01 4.70817122026E-01 4.64257251700E-01 4.57700058234E-01 4.51147395423E-01 4.44601103829E-01 4.38063010119E-01 4.31534926407E-01 4.25018649592E-01 4.18515960703E-01 4.12028624250E-01 4.05558387568E-01 3.99106980170E-01 3.92676113099E-01 3.86267478284E-01 3.79882747892E-01 3.73523573686E-01 3.67191586382E-01 3.60888395011E-01 3.54615586277E-01 3.48374723918E-01 3.42167348076E-01 3.35994974656E-01 3.29859094700E-01 3.23761173758E-01 3.17702651260E-01 3.11684939896E-01 3.05709425000E-01 2.99777463938E-01 2.93890385496E-01 2.88049489288E-01 2.82256045153E-01 2.76511292577E-01 2.70816440111E-01 2.65172664802E-01 2.59581111638E-01 2.54042893002E-01 2.48559088134E-01 2.43130742612E-01 2.37758867845E-01 2.32444440582E-01 2.27188402433E-01 2.21991659418E-01 2.16855081518E-01 2.11779502265E-01 2.06765718335E-01 2.01814489177E-01 1.96926536655E-01 1.92102544717E-01 1.87343159093E-01 1.82648987016E-01 1.78020596965E-01 1.73458518449E-01 1.68963241807E-01 1.64535218049E-01 1.60174858717E-01 1.55882535790E-01 1.51658581611E-01 1.47503288858E-01 1.43416910539E-01 1.39399660029E-01 1.35451711141E-01 1.31573198232E-01 1.27764216347E-01 1.24024821398E-01 1.20355030384E-01 1.16754821647E-01 1.13224135163E-01 1.09762872874E-01 1.06370899061E-01 1.03048040747E-01 9.97940881446E-02 9.66087951403E-02 9.34918798121E-02 9.04430249882E-02 8.74618788406E-02 8.45480555148E-02 8.17011357938E-02 7.89206677983E-02 7.62061677188E-02 7.35571205817E-02 7.09729810466E-02 6.84531742342E-02 6.59970965838E-02 6.36041167398E-02 6.12735764635E-02 5.90047915729E-02 5.67970529043E-02 5.46496272983E-02 5.25617586064E-02 5.05326687166E-02 4.85615585978E-02 4.66476093596E-02 4.47899833269E-02 4.29878251266E-02 4.12402627857E-02 3.95464088380E-02 3.79053614374E-02 3.63162054770E-02 3.47780137109E-02 3.32898478778E-02 3.18507598232E-02 3.04597926199E-02 2.91159816835E-02 2.78183558816E-02 2.65659386350E-02 2.53577490087E-02 2.41928027911E-02 2.30701135596E-02 2.19886937306E-02 2.09475555926E-02 1.99457123206E-02 1.89821789701E-02 1.80559734496E-02 1.71661174693E-02 1.63116374657E-02 1.54915654997E-02 1.47049401280E-02 1.39508072457E-02 1.32282208997E-02 1.25362440716E-02 1.18739494288E-02 1.12404200440E-02 1.06347500815E-02 1.00560454497E-02 9.50342441974E-03 8.97601820920E-03 8.47297153110E-03 7.99344310744E-03 7.53660614723E-03 7.10164878902E-03 6.68777450774E-03 6.29420248609E-03 5.92016795049E-03 5.56492247191E-03 5.22773423194E-03 4.90788825438E-03 4.60468660298E-03 4.31744854578E-03 4.04551068669E-03 3.78822706506E-03 3.54496922388E-03 3.31512624760E-03 3.09810477027E-03 2.89332895493E-03 2.70024044544E-03 2.51829829145E-03 2.34697884777E-03 2.18577564918E-03 2.03419926180E-03 1.89177711208E-03 1.75805329476E-03 1.63258836077E-03 1.51495908644E-03 1.40475822513E-03 1.30159424253E-03 1.20509103684E-03 1.11488764500E-03 1.03063793626E-03 9.52010294212E-04 8.78687288451E-04 8.10365337130E-04 7.46754361428E-04 6.87577433133E-04 6.32570416396E-04 5.81481604738E-04 5.34071354330E-04 4.90111714558E-04 4.49386056817E-04 4.11688702484E-04 3.76824550932E-04 3.44608708451E-04 3.14866118732E-04 2.87431204514E-04 2.62147407746E-04 2.38867486227E-04 2.17450748191E-04 1.97768046999E-04 1.79698214421E-04 1.63125200536E-04 1.47939388197E-04 1.34037957442E-04 1.21324559534E-04 1.09708999984E-04 9.91069307097E-05 8.94395514699E-05 8.06333207211E-05 7.26196759774E-05 6.53347637394E-05 5.87191790276E-05 5.27177145245E-05 4.72791193069E-05 4.23558671211E-05 3.79039341306E-05 3.38825860457E-05 3.02541745179E-05 2.69839426664E-05 2.40398395845E-05 2.13923436531E-05 1.90142944828E-05 1.68807332569E-05 1.49687524598E-05 1.32573464754E-05 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 3.57598307558E-07 3.64822287657E-07 3.72192202450E-07 3.79711000039E-07 3.87381688081E-07 3.95207334996E-07 4.03191071188E-07 4.11336090302E-07 4.19645650500E-07 4.28123075764E-07 4.36771757226E-07 4.45595154527E-07 4.54596797195E-07 4.63780286065E-07 4.73149294711E-07 4.82707570923E-07 4.92458938201E-07 5.02407297287E-07 5.12556627727E-07 5.22910989458E-07 5.33474524436E-07 5.44251458294E-07 5.55246102028E-07 5.66462853725E-07 5.77906200323E-07 5.89580719402E-07 6.01491081019E-07 6.13642049576E-07 6.26038485723E-07 6.38685348306E-07 6.51587696349E-07 6.64750691076E-07 6.78179597981E-07 6.91879788929E-07 7.05856744309E-07 7.20116055223E-07 7.34663425725E-07 7.49504675104E-07 7.64645740207E-07 7.80092677821E-07 7.95851667091E-07 8.11929011994E-07 8.28331143858E-07 8.45064623942E-07 8.62136146051E-07 8.79552539224E-07 8.97320770458E-07 9.15447947499E-07 9.33941321687E-07 9.52808290851E-07 9.72056402277E-07 9.91693355721E-07 1.01172700649E-06 1.03216536859E-06 1.05301661792E-06 1.07428909556E-06 1.09599131109E-06 1.11813194603E-06 1.14071985724E-06 1.16376408055E-06 1.18727383432E-06 1.21125852314E-06 1.23572774161E-06 1.26069127815E-06 1.28615911893E-06 1.31214145188E-06 1.33864867075E-06 1.36569137925E-06 1.39328039533E-06 1.42142675549E-06 1.45014171919E-06 1.47943677337E-06 1.50932363704E-06 1.53981426594E-06 1.57092085738E-06 1.60265585507E-06 1.63503195413E-06 1.66806210615E-06 1.70175952438E-06 1.73613768901E-06 1.77121035259E-06 1.80699154549E-06 1.84349558155E-06 1.88073706379E-06 1.91873089024E-06 1.95749225993E-06 1.99703667897E-06 2.03737996673E-06 2.07853826217E-06 2.12052803032E-06 2.16336606888E-06 2.20706951487E-06 2.25165585159E-06 2.29714291552E-06 2.34354890352E-06 2.39089238008E-06 2.43919228476E-06 2.48846793979E-06 2.53873905773E-06 2.59002574945E-06 2.64234853212E-06 2.69572833742E-06 2.75018651996E-06 2.80574486577E-06 2.86242560104E-06 2.92025140105E-06 2.97924539917E-06 3.03943119618E-06 3.10083286971E-06 3.16347498382E-06 3.22738259890E-06 3.29258128164E-06 3.35909711532E-06 3.42695671020E-06 3.49618721418E-06 3.56681632369E-06 3.63887229473E-06 3.71238395424E-06 3.78738071155E-06 3.86389257025E-06 3.94195014012E-06 4.02158464942E-06 4.10282795738E-06 4.18571256692E-06 4.27027163774E-06 4.35653899950E-06 4.44454916540E-06 4.53433734601E-06 4.62593946335E-06 4.71939216525E-06 4.81473284004E-06 4.91199963151E-06 5.01123145417E-06 5.11246800884E-06 5.21574979855E-06 5.32111814471E-06 5.42861520371E-06 5.53828398373E-06 5.65016836203E-06 5.76431310244E-06 5.88076387335E-06 5.99956726594E-06 6.12077081283E-06 6.24442300718E-06 6.37057332202E-06 6.49927223008E-06 6.63057122404E-06 6.76452283709E-06 6.90118066399E-06 7.04059938254E-06 7.18283477544E-06 7.32794375264E-06 7.47598437416E-06 7.62701587326E-06 7.78109868025E-06 7.93829444662E-06 8.09866606975E-06 8.26227771811E-06 8.42919485694E-06 8.59948427447E-06 8.77321410866E-06 8.95045387451E-06 9.13127449188E-06 9.31574831389E-06 9.50394915593E-06 9.69595232519E-06 9.89183465082E-06 1.00916745147E-05 1.02955518830E-05 1.05035483379E-05 1.07157471104E-05 1.09322331138E-05 1.11530929777E-05 1.13784150825E-05 1.16082895949E-05 1.18428085040E-05 1.20820656584E-05 1.23261568035E-05 1.25751796199E-05 1.28292337627E-05 1.30884209012E-05 1.33528447600E-05 1.36226111602E-05 1.38978280619E-05 1.41786056077E-05 1.44650561664E-05 1.47572943785E-05 1.50554372018E-05 1.53596039586E-05 1.56699163832E-05 1.59864986708E-05 1.63094775275E-05 1.66389822207E-05 1.69751446314E-05 1.73180993067E-05 1.76679835138E-05 1.80249372951E-05 1.83891035246E-05 1.87606279646E-05 1.91396593248E-05 1.95263493214E-05 1.99208527384E-05 2.03233274893E-05 2.07339346806E-05 2.11528386766E-05 2.15802071650E-05 2.20162112244E-05 2.24610253928E-05 2.29148277378E-05 2.33777999278E-05 2.38501273051E-05 2.43319989603E-05 2.48236078080E-05 2.53251506642E-05 2.58368283256E-05 2.63588456500E-05 2.68914116385E-05 2.74347395193E-05 2.79890468337E-05 2.85545555231E-05 2.91314920181E-05 2.97200873296E-05 3.03205771417E-05 3.09332019059E-05 3.15582069382E-05 3.21958425170E-05 3.28463639845E-05 3.35100318486E-05 3.41871118877E-05 3.48778752578E-05 3.55825986012E-05 3.63015641576E-05 3.70350598778E-05 3.77833795396E-05 3.85468228651E-05 3.93256956422E-05 4.01203098471E-05 4.09309837695E-05 4.17580421411E-05 4.26018162661E-05 4.34626441541E-05 4.43408706566E-05 4.52368476056E-05 4.61509339549E-05 4.70834959250E-05 4.80349071501E-05 4.90055488290E-05 4.99958098780E-05 5.10060870880E-05 5.20367852840E-05 5.30883174883E-05 5.41611050869E-05 5.52555779992E-05 5.63721748510E-05 5.75113431519E-05 5.86735394752E-05 5.98592296417E-05 6.10688889085E-05 6.23030021595E-05 6.35620641018E-05 6.48465794649E-05 6.61570632043E-05 6.74940407094E-05 6.88580480158E-05 7.02496320211E-05 7.16693507062E-05 7.31177733605E-05 7.45954808118E-05 7.61030656608E-05 7.76411325209E-05 7.92102982621E-05 8.08111922607E-05 8.24444566537E-05 8.41107465984E-05 8.58107305374E-05 8.75450904690E-05 8.93145222233E-05 9.11197357438E-05 9.29614553746E-05 9.48404201542E-05 9.67573841143E-05 9.87131165859E-05 1.00708402510E-04 1.02744042758E-04 1.04820854453E-04 1.06939671304E-04 1.09101343944E-04 1.11306740274E-04 1.13556745815E-04 1.15852264069E-04 1.18194216884E-04 1.20583544833E-04 1.23021207589E-04 1.25508184322E-04 1.28045474094E-04 1.30634096264E-04 1.33275090906E-04 1.35969519231E-04 1.38718464019E-04 1.41523030060E-04 1.44384344605E-04 1.47303557824E-04 1.50281843276E-04 1.53320398388E-04 1.56420444944E-04 1.59583229583E-04 1.62810024308E-04 1.66102127006E-04 1.69460861981E-04 1.72887580490E-04 1.76383661301E-04 1.79950511257E-04 1.83589565849E-04 1.87302289805E-04 1.91090177694E-04 1.94954754534E-04 1.98897576421E-04 2.02920231166E-04 2.07024338948E-04 2.11211552981E-04 2.15483560190E-04 2.19842081909E-04 2.24288874587E-04 2.28825730513E-04 2.33454478552E-04 2.38176984903E-04 2.42995153864E-04 2.47910928623E-04 2.52926292056E-04 2.58043267553E-04 2.63263919845E-04 2.68590355870E-04 2.74024725635E-04 2.79569223114E-04 2.85226087156E-04 2.90997602412E-04 2.96886100287E-04 3.02893959906E-04 3.09023609106E-04 3.15277525443E-04 3.21658237230E-04 3.28168324583E-04 3.34810420505E-04 3.41587211980E-04 3.48501441098E-04 3.55555906202E-04 3.62753463059E-04 3.70097026056E-04 3.77589569425E-04 3.85234128485E-04 3.93033800924E-04 4.00991748098E-04 4.09111196362E-04 4.17395438431E-04 4.25847834767E-04 4.34471814997E-04 4.43270879365E-04 4.52248600211E-04 4.61408623485E-04 4.70754670291E-04 4.80290538470E-04 4.90020104209E-04 4.99947323694E-04 5.10076234793E-04 5.20410958779E-04 5.30955702089E-04 5.41714758123E-04 5.52692509078E-04 5.63893427833E-04 5.75322079862E-04 5.86983125200E-04 5.98881320444E-04 6.11021520808E-04 6.23408682212E-04 6.36047863429E-04 6.48944228269E-04 6.62103047821E-04 6.75529702738E-04 6.89229685577E-04 7.03208603190E-04 7.17472179167E-04 7.32026256340E-04 7.46876799335E-04 7.62029897186E-04 7.77491766011E-04 7.93268751740E-04 8.09367332915E-04 8.25794123542E-04 8.42555876024E-04 8.59659484140E-04 8.77111986115E-04 8.94920567738E-04 9.13092565569E-04 9.31635470211E-04 9.50556929658E-04 9.69864752722E-04 9.89566912542E-04 1.00967155016E-03 1.03018697822E-03 1.05112168467E-03 1.07248433668E-03 1.09428378448E-03 1.11652906550E-03 1.13922940838E-03 1.16239423727E-03 1.18603317609E-03 1.21015605298E-03 1.23477290481E-03 1.25989398183E-03 1.28552975238E-03 1.31169090776E-03 1.33838836723E-03 1.36563328303E-03 1.39343704567E-03 1.42181128921E-03 1.45076789676E-03 1.48031900607E-03 1.51047701527E-03 1.54125458873E-03 1.57266466311E-03 1.60472045349E-03 1.63743545973E-03 1.67082347290E-03 1.70489858195E-03 1.73967518049E-03 1.77516797379E-03 1.81139198585E-03 1.84836256681E-03 1.88609540037E-03 1.92460651156E-03 1.96391227457E-03 2.00402942084E-03 2.04497504738E-03 2.08676662525E-03 2.12942200829E-03 2.17295944202E-03 2.21739757290E-03 2.26275545762E-03 2.30905257286E-03 2.35630882509E-03 2.40454456080E-03 2.45378057690E-03 2.50403813139E-03 2.55533895435E-03 2.60770525920E-03 2.66115975426E-03 2.71572565462E-03 2.77142669428E-03 2.82828713871E-03 2.88633179764E-03 2.94558603828E-03 3.00607579880E-03 3.06782760228E-03 3.13086857097E-03 3.19522644092E-03 3.26092957710E-03 3.32800698879E-03 3.39648834557E-03 3.46640399358E-03 3.53778497231E-03 3.61066303187E-03 3.68507065071E-03 3.76104105380E-03 3.83860823139E-03 3.91780695826E-03 3.99867281346E-03 4.08124220070E-03 4.16555236927E-03 4.25164143552E-03 4.33954840500E-03 4.42931319521E-03 4.52097665903E-03 4.61458060873E-03 4.71016784083E-03 4.80778216148E-03 4.90746841279E-03 5.00927249969E-03 5.11324141782E-03 5.21942328202E-03 5.32786735577E-03 5.43862408148E-03 5.55174511166E-03 5.66728334100E-03 5.78529293943E-03 5.90582938612E-03 6.02894950454E-03 6.15471149856E-03 6.28317498959E-03 6.41440105486E-03 6.54845226690E-03 6.68539273414E-03 6.82528814279E-03 6.96820579995E-03 7.11421467810E-03 7.26338546086E-03 7.41579059024E-03 7.57150431527E-03 7.73060274217E-03 7.89316388606E-03 8.05926772425E-03 8.22899625122E-03 8.40243353526E-03 8.57966577689E-03 8.76078136917E-03 8.94587095980E-03 9.13502751519E-03 9.32834638664E-03 9.52592537844E-03 9.72786481829E-03 9.93426762981E-03 1.01452394074E-02 1.03608884937E-02 1.05813260589E-02 1.08066661832E-02 1.10370259419E-02 1.12725254927E-02 1.15132881661E-02 1.17594405589E-02 1.20111126305E-02 1.22684378020E-02 1.25315530592E-02 1.28005990586E-02 1.30757202363E-02 1.33570649213E-02 1.36447854522E-02 1.39390382971E-02 1.42399841785E-02 1.45477882012E-02 1.48626199851E-02 1.51846538020E-02 1.55140687171E-02 1.58510487348E-02 1.61957829495E-02 1.65484657015E-02 1.69092967379E-02 1.72784813783E-02 1.76562306871E-02 1.80427616501E-02 1.84382973580E-02 1.88430671953E-02 1.92573070358E-02 1.96812594446E-02 2.01151738862E-02 2.05593069400E-02 2.10139225229E-02 2.14792921191E-02 2.19556950174E-02 2.24434185564E-02 2.29427583784E-02 2.34540186901E-02 2.39775125341E-02 2.45135620675E-02 2.50624988506E-02 2.56246641450E-02 2.62004092212E-02 2.67900956771E-02 2.73940957660E-02 2.80127927361E-02 2.86465811810E-02 2.92958674014E-02 2.99610697793E-02 3.06426191636E-02 3.13409592693E-02 3.20565470889E-02 3.27898533176E-02 3.35413627926E-02 3.43115749464E-02 3.51010042744E-02 3.59101808186E-02 3.67396506664E-02 3.75899764653E-02 3.84617379549E-02 3.93555325150E-02 4.02719757323E-02 4.12117019845E-02 4.21753650435E-02 4.31636386970E-02 4.41772173912E-02 4.52168168922E-02 4.62831749696E-02 4.73770521003E-02 4.84992321958E-02 4.96505233503E-02 5.08317586142E-02 5.20437967892E-02 5.32875232498E-02 5.45638507886E-02 5.58737204881E-02 5.72181026188E-02 5.85979975643E-02 6.00144367737E-02 6.14684837435E-02 6.29612350275E-02 6.44938212769E-02 6.60674083110E-02 6.76831982188E-02 6.93424304922E-02 7.10463831922E-02 7.27963741477E-02 7.45937621879E-02 7.64399484104E-02 7.83363774826E-02 8.02845389802E-02 8.22859687611E-02 8.43422503773E-02 8.64550165228E-02 8.86259505209E-02 9.08567878498E-02 9.31493177062E-02 9.55053846101E-02 9.79268900487E-02 1.00415794160E-01 1.02974117459E-01 1.05603942604E-01 1.08307416200E-01 1.11086750654E-01 1.13944226059E-01 1.16882192130E-01 1.19903070176E-01 1.23009355114E-01 1.26203617523E-01 1.29488505747E-01 1.32866748024E-01 1.36341154670E-01 1.39914620290E-01 1.43590126036E-01 1.47370741896E-01 1.51259629026E-01 1.55260042110E-01 1.59375331759E-01 1.63608946939E-01 1.67964437430E-01 1.72445456315E-01 1.77055762494E-01 1.81799223213E-01 1.86679816633E-01 1.91701634395E-01 1.96868884211E-01 2.02185892466E-01 2.07657106823E-01 2.13287098827E-01 2.19080566517E-01 2.25042337019E-01 2.31177369138E-01 2.37490755915E-01 2.43987727181E-01 2.50673652056E-01 2.57554041428E-01 2.64634550375E-01 2.71920980535E-01 2.79419282411E-01 2.87135557606E-01 2.95076060971E-01 3.03247202661E-01 3.11655550089E-01 3.20307829757E-01 3.29210928962E-01 3.38371897360E-01 3.47797948367E-01 3.57496460394E-01 3.67474977891E-01 3.77741212193E-01 3.88303042134E-01 3.99168514429E-01 4.10345843800E-01 4.21843412811E-01 4.33669771417E-01 4.45833636185E-01 4.58343889167E-01 4.71209576414E-01 4.84439906088E-01 4.98044246161E-01 5.12032121665E-01 5.26413211471E-01 5.41197344566E-01 5.56394495797E-01 5.72014781050E-01 5.88068451843E-01 6.04565889282E-01 6.21517597367E-01 6.38934195597E-01 6.56826410851E-01 6.75205068494E-01 6.94081082699E-01 7.13465445912E-01 7.33369217453E-01 7.53803511198E-01 7.74779482312E-01 7.96308312984E-01 8.18401197144E-01 8.41069324099E-01 8.64323861075E-01 8.88175934603E-01 9.12636610734E-01 9.37716874029E-01 9.63427605299E-01 9.89779558058E-01 1.01678333365E+00 1.04444935503E+00 1.07278783918E+00 1.10180876807E+00 1.13152185824E+00 1.16193652895E+00 1.19306186875E+00 1.22490660072E+00 1.25747904612E+00 1.29078708656E+00 1.32483812472E+00 1.35963904358E+00 1.39519616410E+00 1.43151520156E+00 1.46860122043E+00 1.50645858780E+00 1.54509092559E+00 1.58450106132E+00 1.62469097777E+00 1.66566176143E+00 1.70741354985E+00 1.74994547809E+00 1.79325562421E+00 1.83734095405E+00 1.88219726538E+00 1.92781913158E+00 1.97419984496E+00 2.02133135997E+00 2.06920423643E+00 2.11780758306E+00 2.16712900135E+00 2.21715453027E+00 2.26786859182E+00 2.31925393784E+00 2.37129159834E+00 2.42396083157E+00 2.47723907618E+00 2.53110190595E+00 2.58552298711E+00 2.64047403892E+00 2.69592479773E+00 2.75184298488E+00 2.80819427894E+00 2.86494229257E+00 2.92204855449E+00 2.97947249693E+00 3.03717144907E+00 3.09510063667E+00 3.15321318863E+00 3.21146015054E+00 3.26979050596E+00 3.32815120555E+00 3.38648720460E+00 3.44474150933E+00 3.50285523211E+00 3.56076765621E+00 3.61841631011E+00 3.67573705176E+00 3.73266416303E+00 3.78913045438E+00 3.84506737999E+00 3.90040516342E+00 3.95507293379E+00 4.00899887234E+00 4.06211036944E+00 4.11433419173E+00 4.16559665915E+00 4.21582383152E+00 4.26494170430E+00 4.31287641298E+00 4.35955444547E+00 4.40490286190E+00 4.44884952099E+00 4.49132331210E+00 4.53225439220E+00 4.57157442637E+00 4.60921683116E+00 4.64511701916E+00 4.67921264387E+00 4.71144384325E+00 4.74175348079E+00 4.77008738231E+00 4.79639456740E+00 4.82062747353E+00 4.84274217155E+00 4.86269857092E+00 4.88046061302E+00 4.89599645109E+00 4.90927861517E+00 4.92028416066E+00 4.92899479895E+00 4.93539700895E+00 4.93948212805E+00 4.94124642154E+00 4.94069112947E+00 4.93782248994E+00 4.93265173814E+00 4.92519508070E+00 4.91547364474E+00 4.90351340153E+00 4.88934506472E+00 4.87300396325E+00 4.85452988932E+00 4.83396692194E+00 4.81136322686E+00 4.78677083369E+00 4.76024539146E+00 4.73184590374E+00 4.70163444495E+00 4.66967585931E+00 4.63603744426E+00 4.60078862024E+00 4.56400058885E+00 4.52574598143E+00 4.48609850042E+00 4.44513255576E+00 4.40292289870E+00 4.35954425553E+00 4.31507096381E+00 4.26957661370E+00 4.22313369691E+00 4.17581326625E+00 4.12768460824E+00 4.07881493164E+00 4.02926907477E+00 3.97910923412E+00 3.92839471716E+00 3.87718172183E+00 3.82552314514E+00 3.77346842327E+00 3.72106340503E+00 3.66835026035E+00 3.61536742511E+00 3.56214958275E+00 3.50872768282E+00 3.45512899560E+00 3.40137720112E+00 3.34749250982E+00 3.29349181121E+00 3.23938884529E+00 3.18519439081E+00 3.13091646260E+00 3.07656050948E+00 3.02212960275E+00 2.96762460460E+00 2.91304430452E+00 2.85839315463E+00 2.80370465716E+00 2.74901915748E+00 2.69437626299E+00 2.63981479944E+00 2.58537276951E+00 2.53108731372E+00 2.47699467371E+00 2.42313015781E+00 2.36952810915E+00 2.31622187605E+00 2.26324378492E+00 2.21062511559E+00 2.15839607913E+00 2.10658579795E+00 2.05522228833E+00 2.00433244535E+00 1.95394203018E+00 1.90407565969E+00 1.85475679833E+00 1.80600775233E+00 1.75784966596E+00 1.71029826426E+00 1.66337673443E+00 1.61710273578E+00 1.57149277185E+00 1.52656219695E+00 1.48232522458E+00 1.43879493767E+00 1.39598330042E+00 1.35390117191E+00 1.31255832125E+00 1.27196344414E+00 1.23212418097E+00 1.19304713618E+00 1.15473789888E+00 1.11720106469E+00 1.08044025865E+00 1.04445815914E+00 1.00925652274E+00 9.74836209999E-01 9.41197211907E-01 9.08338677103E-01 8.76258939703E-01 8.44955547667E-01 8.14425291637E-01 7.84664234160E-01 7.55667739240E-01 7.27430502131E-01 6.99946579312E-01 6.73209418573E-01 6.47211889142E-01 6.21946311796E-01 5.97404488888E-01 5.73577734238E-01 5.50456902823E-01 5.28032420215E-01 5.06294311720E-01 4.85232231160E-01 4.64835489252E-01 4.45093081551E-01 4.25993715901E-01 4.07525839359E-01 3.89677664569E-01 3.72437195528E-01 3.55792252735E-01 3.39730497688E-01 3.24239456693E-01 3.09306543982E-01 2.94919084102E-01 2.81064333569E-01 2.67729501762E-01 2.54901771051E-01 2.42568316154E-01 2.30716322694E-01 2.19333004979E-01 2.08405622976E-01 1.97921498488E-01 1.87868030547E-01 1.78232709994E-01 1.69003133282E-01 1.60167015493E-01 1.51712202573E-01 1.43626682806E-01 1.35898597527E-01 1.28516251091E-01 1.21468120112E-01 1.14742861985E-01 1.08329322700E-01 1.02216543978E-01 9.63937697367E-02 9.08504519010E-02 8.55762555881E-02 8.05610636768E-02 7.57949807842E-02 7.12683366712E-02 6.69716890945E-02 6.28958261283E-02 5.90317679757E-02 5.53707682902E-02 5.19043150300E-02 4.86241308648E-02 4.55221731570E-02 4.25906335380E-02 3.98219371003E-02 3.72087412257E-02 3.47439340713E-02 3.24206327305E-02 3.02321810924E-02 2.81721474153E-02 2.62343216360E-02 2.44127124318E-02 2.27015440540E-02 2.10952529506E-02 1.95884841949E-02 1.81760877370E-02 1.68531144954E-02 1.56148123021E-02 1.44566217194E-02 1.33741717404E-02 1.23632753902E-02 1.14199252385E-02 1.05402888402E-02 9.72070411338E-03 8.95767467019E-03 8.24786510956E-03 7.58809628498E-03 6.97534055713E-03 6.40671704198E-03 5.87948686414E-03 5.39104842475E-03 4.93893269269E-03 4.52079852776E-03 4.13442804339E-03 3.77772201666E-03 3.44869535241E-03 3.14547260816E-03 2.86628358589E-03 2.60945899626E-03 2.37342620075E-03 2.15670503626E-03 1.95790372683E-03 1.77571488624E-03 1.60891161521E-03 1.45634369631E-03 1.31693388945E-03 1.18967433022E-03 1.07362303322E-03 9.67900502029E-04 8.71686447073E-04 7.84216612438E-04 7.04779712202E-04 6.32714476634E-04 5.67406808277E-04 5.08287047610E-04 4.54827347743E-04 4.06539157308E-04 3.62970810464E-04 3.23705222704E-04 2.88357690911E-04 2.56573795926E-04 2.28027405698E-04 2.02418776883E-04 1.79472752656E-04 1.58937054291E-04 1.40580663998E-04 1.24192296363E-04 1.09578955640E-04 9.65645760879E-05 8.49887424548E-05 7.47054876859E-05 6.55821648711E-05 5.74983904470E-05 5.03450556453E-05 4.40234031870E-05 3.84441662356E-05 3.35267666444E-05 2.91985695717E-05 2.53941915792E-05 2.20548593805E-05 1.91278164707E-05 1.65657749300E-05 1.43264097711E-05 1.23718932776E-05 1.06684668620E-05 9.18604806154E-06 7.89787037620E-06 6.78015374995E-06 5.81180358561E-06 4.97413628199E-06 4.25062937617E-06 3.62669446920E-06 3.08947120905E-06 2.62764069788E-06 2.23125678389E-06 1.89159378809E-06 1.60100930535E-06 1.35282080505E-06 1.14119484003E-06 9.61047753224E-07 8.07956848808E-07 6.78081068873E-07 5.68090287757E-07 4.75102403608E-07 3.96627470981E-07 3.30518178962E-07 2.74926036604E-07 2.28262681353E-07 1.89165776667E-07 1.56469582375E-07 1.29182464133E-07 1.06452737290E-07 8.75550766753E-08 7.18734654608E-08 5.88857258945E-08 4.81500825865E-08 3.92935144625E-08 3.20016775292E-08 2.60102042739E-08 2.10972070027E-08 1.70768318614E-08 1.37937278412E-08 1.11183108836E-08 8.94271740968E-09 7.17735433305E-09 5.74796400892E-09 4.59313272639E-09 3.66218039183E-09 2.91337707237E-09 2.31243917017E-09 1.83126426981E-09 1.44686922466E-09 1.14050090142E-09 8.96893254979E-10 7.03648122712E-10 5.50720368265E-10 4.29990822262E-10 3.34912911091E-10 2.60220978224E-10 2.01690125567E-10 1.55938970599E-10 1.20268060609E-10 9.25278365048E-11 7.10110210082E-11 5.43651418420E-11 4.15216097580E-11 3.16383713420E-11 2.40536628831E-11 1.82488175987E-11 1.38184359073E-11 1.04465274135E-11 7.88748264362E-12 5.95093997217E-12 4.48978517203E-12 3.37757939841E-12 2.53345264749E-12 1.89467319912E-12 1.41272320086E-12 1.05019006951E-12 7.78311574516E-13 5.75043075153E-13 4.23540549111E-13 3.10973675974E-13 2.27600086943E-13 1.66045609033E-13 1.20746462181E-13 8.75183685776E-14 6.32247877122E-14 4.55223170750E-14 3.26659619972E-14 2.33606978643E-14 1.66487044972E-14 1.18239941367E-14 8.36800246538E-15 5.90116527817E-15 4.14664198291E-15 2.90323591456E-15 2.02525272439E-15 1.40757374832E-15 9.74634753704E-16 6.72318455803E-16 4.62012810112E-16 3.16273001213E-16 2.15666379451E-16 1.46486613465E-16 9.91040405771E-17 6.67798302418E-17 4.48169407765E-17 2.99546534374E-17 1.99385537214E-17 1.32163690536E-17 8.72371604548E-18 5.73380961455E-18 3.75248305878E-18 2.44517017351E-18 1.58633637051E-18 1.02460882181E-18 6.58837179770E-19 4.21731164914E-19 2.68726855696E-19 1.70444981325E-19 1.07605614359E-19 6.76149609008E-20 4.22850856259E-20 2.63176647941E-20 1.63005471811E-20 1.00468628099E-20 6.16184495309E-21 3.76029051865E-21 2.28318177523E-21 1.37925933645E-21 8.28925320437E-22 4.95594367647E-22 2.94751502715E-22 1.74373868359E-22 1.02607534684E-22 6.00518119841E-23 3.49541134835E-23 2.02335386415E-23 1.16472284258E-23 6.66693348325E-24 3.79452804272E-24 2.14729946355E-24 1.20810729812E-24 6.75726623763E-25 3.75719309754E-25 2.07662002947E-25 1.14084177016E-25 6.22934227428E-26 3.38049786958E-26 1.82311410394E-26 9.77044840859E-27 5.20301499130E-27 2.75301003622E-27 1.44725336820E-27 7.55852475032E-28 3.92153920418E-28 2.02103670587E-28 1.03457204025E-28 5.26001101255E-29 2.65596371707E-29 1.33179407898E-29 6.63133649639E-30 3.27856183268E-30 1.60935921701E-30 7.84293412308E-31 3.79427193466E-31 1.82209359306E-31 8.68506273087E-32 4.10868337711E-32 1.92897627251E-32 8.98694987482E-33 4.15456320459E-33 1.90560154142E-33 8.67157951278E-34 3.91461529070E-34 1.75295090317E-34 7.78582928969E-35 3.42972091124E-35 1.49828842962E-35 6.49050381407E-36 2.78786003606E-36 1.18723300369E-36 5.01228648064E-37 2.09764917255E-37 8.70138941352E-38 3.57737515469E-38 1.45754328900E-38 5.88464276243E-39 2.35407657280E-39 9.33002233892E-40 3.66324334805E-40 1.42471765904E-40 5.48820529203E-41 2.09376785532E-41 7.91008338668E-42 2.95900187419E-42 1.09591765952E-42 4.01823697126E-43 1.45839138950E-43 5.23900862364E-44 1.86258333736E-44 6.55282460931E-45 2.28108674767E-45 7.85614015200E-46 2.67660373403E-46 9.02026247510E-47 3.00653897341E-47 9.91012011557E-48 3.23003168746E-48 1.04088154759E-48 3.31598748802E-49 1.04421851693E-49 3.25002134870E-50 9.99645991156E-51 3.03822404329E-51 9.12335888659E-52 2.70644020249E-52 7.93044607965E-53 2.29508384596E-53 6.55914104673E-54 1.85092161961E-54 5.15663450330E-55 1.41816250552E-55 3.84955452932E-56 1.03124703867E-56 2.72599512768E-57 7.10950460354E-58 1.82913897877E-58 4.64181444577E-59 1.16172293273E-59 2.86701834357E-60 6.97606150677E-61 1.67332474710E-61 3.95619630119E-62 9.21807063874E-63 2.11642621930E-63 4.78743398013E-64 1.06677797741E-64 2.34126852143E-65 5.06020433571E-66 1.07685582961E-66 2.25606764563E-67 4.65246806314E-68 9.44240037865E-69 1.88572976062E-69 TDDFPT/Examples/pseudo/H.pz-rrkjus.UPF0000644000175000017500000056223012341371476015731 0ustar mbamba Generated using Andrea Dal Corso code (rrkj3) Author: Andrea Dal Corso Generation date: unknown Info: H LDA 1s1 RRKJ3 US 0 The Pseudo was generated with a Non-Relativistic Calculation 1.10000000000E+00 Local Potential cutoff radius nl pn l occ Rcut Rcut US E pseu 1S 1 0 1.00 1.10000000000 1.20000000000 0.00000000000 1S 1 0 0.00 1.10000000000 1.20000000000 0.00000000000 2P 2 1 0.00 1.10000000000 1.10000000000 0.00000000000 0 Version Number H Element US Ultrasoft pseudopotential F Nonlinear Core Correction SLA PZ NOGX NOGC PZ Exchange-Correlation functional 1.00000000000 Z valence -0.60281129472 Total energy 0.0000000 0.0000000 Suggested cutoff for wfc and rho 1 Max angular momentum component 1061 Number of points in mesh 1 2 Number of Wavefunctions, Number of Projectors Wavefunctions nl l occ 1S 0 1.00 2.47875217667E-03 2.50366405020E-03 2.52882629223E-03 2.55424141899E-03 2.57991197203E-03 2.60584051841E-03 2.63202965101E-03 2.65848198878E-03 2.68520017695E-03 2.71218688739E-03 2.73944481877E-03 2.76697669691E-03 2.79478527504E-03 2.82287333402E-03 2.85124368268E-03 2.87989915809E-03 2.90884262581E-03 2.93807698022E-03 2.96760514478E-03 2.99743007233E-03 3.02755474538E-03 3.05798217642E-03 3.08871540824E-03 3.11975751416E-03 3.15111159844E-03 3.18278079651E-03 3.21476827531E-03 3.24707723361E-03 3.27971090234E-03 3.31267254490E-03 3.34596545747E-03 3.37959296938E-03 3.41355844340E-03 3.44786527610E-03 3.48251689821E-03 3.51751677491E-03 3.55286840622E-03 3.58857532733E-03 3.62464110897E-03 3.66106935773E-03 3.69786371648E-03 3.73502786469E-03 3.77256551879E-03 3.81048043259E-03 3.84877639761E-03 3.88745724348E-03 3.92652683831E-03 3.96598908909E-03 4.00584794209E-03 4.04610738322E-03 4.08677143846E-03 4.12784417426E-03 4.16932969790E-03 4.21123215800E-03 4.25355574482E-03 4.29630469075E-03 4.33948327074E-03 4.38309580267E-03 4.42714664783E-03 4.47164021135E-03 4.51658094261E-03 4.56197333574E-03 4.60782192999E-03 4.65413131028E-03 4.70090610758E-03 4.74815099941E-03 4.79587071030E-03 4.84407001225E-03 4.89275372524E-03 4.94192671768E-03 4.99159390691E-03 5.04176025969E-03 5.09243079270E-03 5.14361057303E-03 5.19530471871E-03 5.24751839918E-03 5.30025683587E-03 5.35352530266E-03 5.40732912644E-03 5.46167368764E-03 5.51656442076E-03 5.57200681492E-03 5.62800641440E-03 5.68456881922E-03 5.74169968565E-03 5.79940472684E-03 5.85768971334E-03 5.91656047368E-03 5.97602289501E-03 6.03608292360E-03 6.09674656552E-03 6.15801988717E-03 6.21990901594E-03 6.28242014080E-03 6.34555951291E-03 6.40933344626E-03 6.47374831829E-03 6.53881057055E-03 6.60452670931E-03 6.67090330626E-03 6.73794699909E-03 6.80566449223E-03 6.87406255750E-03 6.94314803475E-03 7.01292783259E-03 7.08340892905E-03 7.15459837231E-03 7.22650328138E-03 7.29913084679E-03 7.37248833137E-03 7.44658307092E-03 7.52142247499E-03 7.59701402758E-03 7.67336528790E-03 7.75048389114E-03 7.82837754923E-03 7.90705405159E-03 7.98652126596E-03 8.06678713910E-03 8.14785969768E-03 8.22974704902E-03 8.31245738192E-03 8.39599896749E-03 8.48038015995E-03 8.56560939750E-03 8.65169520312E-03 8.73864618547E-03 8.82647103973E-03 8.91517854844E-03 9.00477758244E-03 9.09527710170E-03 9.18668615624E-03 9.27901388706E-03 9.37226952701E-03 9.46646240171E-03 9.56160193054E-03 9.65769762754E-03 9.75475910234E-03 9.85279606119E-03 9.95181830785E-03 1.00518357446E-02 1.01528583734E-02 1.02548962964E-02 1.03579597176E-02 1.04620589434E-02 1.05672043839E-02 1.06734065535E-02 1.07806760727E-02 1.08890236686E-02 1.09984601758E-02 1.11089965382E-02 1.12206438096E-02 1.13334131547E-02 1.14473158505E-02 1.15623632875E-02 1.16785669704E-02 1.17959385198E-02 1.19144896728E-02 1.20342322847E-02 1.21551783299E-02 1.22773399031E-02 1.24007292204E-02 1.25253586211E-02 1.26512405680E-02 1.27783876495E-02 1.29068125805E-02 1.30365282034E-02 1.31675474901E-02 1.32998835424E-02 1.34335495942E-02 1.35685590122E-02 1.37049252974E-02 1.38426620865E-02 1.39817831533E-02 1.41223024102E-02 1.42642339090E-02 1.44075918431E-02 1.45523905484E-02 1.46986445049E-02 1.48463683381E-02 1.49955768205E-02 1.51462848730E-02 1.52985075667E-02 1.54522601239E-02 1.56075579200E-02 1.57644164849E-02 1.59228515045E-02 1.60828788226E-02 1.62445144419E-02 1.64077745263E-02 1.65726754018E-02 1.67392335586E-02 1.69074656527E-02 1.70773885075E-02 1.72490191153E-02 1.74223746395E-02 1.75974724156E-02 1.77743299537E-02 1.79529649395E-02 1.81333952368E-02 1.83156388887E-02 1.84997141198E-02 1.86856393377E-02 1.88734331352E-02 1.90631142916E-02 1.92547017754E-02 1.94482147454E-02 1.96436725531E-02 1.98410947444E-02 2.00405010617E-02 2.02419114458E-02 2.04453460379E-02 2.06508251817E-02 2.08583694252E-02 2.10679995230E-02 2.12797364384E-02 2.14936013451E-02 2.17096156298E-02 2.19278008943E-02 2.21481789570E-02 2.23707718562E-02 2.25956018511E-02 2.28226914251E-02 2.30520632872E-02 2.32837403749E-02 2.35177458560E-02 2.37541031313E-02 2.39928358367E-02 2.42339678457E-02 2.44775232717E-02 2.47235264703E-02 2.49720020423E-02 2.52229748352E-02 2.54764699467E-02 2.57325127264E-02 2.59911287788E-02 2.62523439657E-02 2.65161844089E-02 2.67826764926E-02 2.70518468664E-02 2.73237224473E-02 2.75983304232E-02 2.78756982552E-02 2.81558536803E-02 2.84388247142E-02 2.87246396542E-02 2.90133270822E-02 2.93049158670E-02 2.95994351679E-02 2.98969144369E-02 3.01973834223E-02 3.05008721712E-02 3.08074110328E-02 3.11170306611E-02 3.14297620184E-02 3.17456363781E-02 3.20646853279E-02 3.23869407729E-02 3.27124349390E-02 3.30412003759E-02 3.33732699603E-02 3.37086768996E-02 3.40474547346E-02 3.43896373435E-02 3.47352589447E-02 3.50843541008E-02 3.54369577216E-02 3.57931050677E-02 3.61528317540E-02 3.65161737537E-02 3.68831674012E-02 3.72538493962E-02 3.76282568072E-02 3.80064270752E-02 3.83883980176E-02 3.87742078317E-02 3.91638950990E-02 3.95574987884E-02 3.99550582607E-02 4.03566132720E-02 4.07622039784E-02 4.11718709391E-02 4.15856551212E-02 4.20035979034E-02 4.24257410805E-02 4.28521268670E-02 4.32827979020E-02 4.37177972528E-02 4.41571684197E-02 4.46009553403E-02 4.50492023936E-02 4.55019544046E-02 4.59592566490E-02 4.64211548574E-02 4.68876952200E-02 4.73589243911E-02 4.78348894942E-02 4.83156381261E-02 4.88012183620E-02 4.92916787605E-02 4.97870683679E-02 5.02874367236E-02 5.07928338649E-02 5.13033103319E-02 5.18189171727E-02 5.23397059484E-02 5.28657287384E-02 5.33970381452E-02 5.39336873004E-02 5.44757298692E-02 5.50232200564E-02 5.55762126115E-02 5.61347628341E-02 5.66989265798E-02 5.72687602655E-02 5.78443208748E-02 5.84256659645E-02 5.90128536694E-02 5.96059427089E-02 6.02049923924E-02 6.08100626252E-02 6.14212139150E-02 6.20385073774E-02 6.26620047422E-02 6.32917683596E-02 6.39278612067E-02 6.45703468932E-02 6.52192896681E-02 6.58747544264E-02 6.65368067150E-02 6.72055127397E-02 6.78809393718E-02 6.85631541543E-02 6.92522253093E-02 6.99482217447E-02 7.06512130604E-02 7.13612695564E-02 7.20784622388E-02 7.28028628274E-02 7.35345437631E-02 7.42735782143E-02 7.50200400853E-02 7.57740040228E-02 7.65355454239E-02 7.73047404433E-02 7.80816660012E-02 7.88663997907E-02 7.96590202859E-02 8.04596067495E-02 8.12682392409E-02 8.20849986239E-02 8.29099665752E-02 8.37432255922E-02 8.45848590016E-02 8.54349509673E-02 8.62935864994E-02 8.71608514620E-02 8.80368325824E-02 8.89216174594E-02 8.98152945722E-02 9.07179532894E-02 9.16296838775E-02 9.25505775103E-02 9.34807262781E-02 9.44202231963E-02 9.53691622155E-02 9.63276382305E-02 9.72957470895E-02 9.82735856044E-02 9.92612515596E-02 1.00258843723E-01 1.01266461854E-01 1.02284206716E-01 1.03312180083E-01 1.04350484755E-01 1.05399224562E-01 1.06458504379E-01 1.07528430136E-01 1.08609108825E-01 1.09700648516E-01 1.10803158362E-01 1.11916748617E-01 1.13041530640E-01 1.14177616911E-01 1.15325121038E-01 1.16484157773E-01 1.17654843022E-01 1.18837293852E-01 1.20031628511E-01 1.21237966433E-01 1.22456428253E-01 1.23687135817E-01 1.24930212199E-01 1.26185781705E-01 1.27453969895E-01 1.28734903588E-01 1.30028710878E-01 1.31335521148E-01 1.32655465080E-01 1.33988674669E-01 1.35335283237E-01 1.36695425446E-01 1.38069237311E-01 1.39456856215E-01 1.40858420921E-01 1.42274071587E-01 1.43703949778E-01 1.45148198484E-01 1.46606962130E-01 1.48080386595E-01 1.49568619223E-01 1.51071808836E-01 1.52590105757E-01 1.54123661815E-01 1.55672630368E-01 1.57237166314E-01 1.58817426107E-01 1.60413567775E-01 1.62025750934E-01 1.63654136803E-01 1.65298888222E-01 1.66960169667E-01 1.68638147269E-01 1.70332988825E-01 1.72044863823E-01 1.73773943450E-01 1.75520400617E-01 1.77284409970E-01 1.79066147911E-01 1.80865792617E-01 1.82683524053E-01 1.84519523993E-01 1.86373976039E-01 1.88247065639E-01 1.90138980102E-01 1.92049908621E-01 1.93980042291E-01 1.95929574127E-01 1.97898699084E-01 1.99887614075E-01 2.01896517995E-01 2.03925611734E-01 2.05975098205E-01 2.08045182357E-01 2.10136071201E-01 2.12247973827E-01 2.14381101427E-01 2.16535667316E-01 2.18711886952E-01 2.20909977959E-01 2.23130160148E-01 2.25372655539E-01 2.27637688384E-01 2.29925485187E-01 2.32236274730E-01 2.34570288094E-01 2.36927758682E-01 2.39308922244E-01 2.41714016897E-01 2.44143283153E-01 2.46596963942E-01 2.49075304632E-01 2.51578553060E-01 2.54106959553E-01 2.56660776954E-01 2.59240260646E-01 2.61845668580E-01 2.64477261300E-01 2.67135301966E-01 2.69820056385E-01 2.72531793034E-01 2.75270783090E-01 2.78037300453E-01 2.80831621778E-01 2.83654026500E-01 2.86504796860E-01 2.89384217939E-01 2.92292577681E-01 2.95230166924E-01 2.98197279430E-01 3.01194211912E-01 3.04221264067E-01 3.07278738601E-01 3.10366941265E-01 3.13486180883E-01 3.16636769379E-01 3.19819021816E-01 3.23033256422E-01 3.26279794623E-01 3.29558961075E-01 3.32871083698E-01 3.36216493707E-01 3.39595525645E-01 3.43008517419E-01 3.46455810330E-01 3.49937749111E-01 3.53454681959E-01 3.57006960569E-01 3.60594940173E-01 3.64218979572E-01 3.67879441171E-01 3.71576691022E-01 3.75311098851E-01 3.79083038103E-01 3.82892885975E-01 3.86741023455E-01 3.90627835359E-01 3.94553710372E-01 3.98519041085E-01 4.02524224034E-01 4.06569659741E-01 4.10655752752E-01 4.14782911682E-01 4.18951549248E-01 4.23162082318E-01 4.27414931949E-01 4.31710523429E-01 4.36049286322E-01 4.40431654506E-01 4.44858066223E-01 4.49328964117E-01 4.53844795282E-01 4.58406011305E-01 4.63013068311E-01 4.67666427010E-01 4.72366552741E-01 4.77113915521E-01 4.81908990090E-01 4.86752255960E-01 4.91644197461E-01 4.96585303791E-01 5.01576069066E-01 5.06616992366E-01 5.11708577787E-01 5.16851334492E-01 5.22045776761E-01 5.27292424043E-01 5.32591801007E-01 5.37944437595E-01 5.43350869074E-01 5.48811636094E-01 5.54327284735E-01 5.59898366565E-01 5.65525438700E-01 5.71209063849E-01 5.76949810380E-01 5.82748252374E-01 5.88604969678E-01 5.94520547970E-01 6.00495578812E-01 6.06530659713E-01 6.12626394184E-01 6.18783391806E-01 6.25002268283E-01 6.31283645507E-01 6.37628151622E-01 6.44036421083E-01 6.50509094723E-01 6.57046819815E-01 6.63650250136E-01 6.70320046036E-01 6.77056874498E-01 6.83861409212E-01 6.90734330637E-01 6.97676326071E-01 7.04688089719E-01 7.11770322763E-01 7.18923733432E-01 7.26149037074E-01 7.33446956224E-01 7.40818220682E-01 7.48263567579E-01 7.55783741456E-01 7.63379494337E-01 7.71051585804E-01 7.78800783071E-01 7.86627861067E-01 7.94533602503E-01 8.02518797962E-01 8.10584245970E-01 8.18730753078E-01 8.26959133943E-01 8.35270211411E-01 8.43664816596E-01 8.52143788966E-01 8.60707976425E-01 8.69358235399E-01 8.78095430921E-01 8.86920436717E-01 8.95834135297E-01 9.04837418036E-01 9.13931185271E-01 9.23116346387E-01 9.32393819906E-01 9.41764533584E-01 9.51229424501E-01 9.60789439152E-01 9.70445533549E-01 9.80198673307E-01 9.90049833749E-01 1.00000000000E+00 1.01005016708E+00 1.02020134003E+00 1.03045453395E+00 1.04081077419E+00 1.05127109638E+00 1.06183654655E+00 1.07250818125E+00 1.08328706767E+00 1.09417428371E+00 1.10517091808E+00 1.11627807046E+00 1.12749685158E+00 1.13882838332E+00 1.15027379886E+00 1.16183424273E+00 1.17351087099E+00 1.18530485132E+00 1.19721736312E+00 1.20924959766E+00 1.22140275816E+00 1.23367805996E+00 1.24607673059E+00 1.25860000993E+00 1.27124915032E+00 1.28402541669E+00 1.29693008667E+00 1.30996445073E+00 1.32312981234E+00 1.33642748803E+00 1.34985880758E+00 1.36342511413E+00 1.37712776434E+00 1.39096812846E+00 1.40494759056E+00 1.41906754859E+00 1.43332941456E+00 1.44773461466E+00 1.46228458943E+00 1.47698079388E+00 1.49182469764E+00 1.50681778511E+00 1.52196155562E+00 1.53725752355E+00 1.55270721851E+00 1.56831218549E+00 1.58407398499E+00 1.59999419322E+00 1.61607440219E+00 1.63231621996E+00 1.64872127070E+00 1.66529119495E+00 1.68202764970E+00 1.69893230862E+00 1.71600686218E+00 1.73325301787E+00 1.75067250030E+00 1.76826705143E+00 1.78603843075E+00 1.80398841540E+00 1.82211880039E+00 1.84043139878E+00 1.85892804185E+00 1.87761057926E+00 1.89648087930E+00 1.91554082901E+00 1.93479233440E+00 1.95423732064E+00 1.97387773223E+00 1.99371553324E+00 2.01375270747E+00 2.03399125865E+00 2.05443321064E+00 2.07508060767E+00 2.09593551449E+00 2.11700001661E+00 2.13827622050E+00 2.15976625378E+00 2.18147226550E+00 2.20339642626E+00 2.22554092849E+00 2.24790798668E+00 2.27049983753E+00 2.29331874026E+00 2.31636697678E+00 2.33964685193E+00 2.36316069371E+00 2.38691085352E+00 2.41089970642E+00 2.43512965129E+00 2.45960311116E+00 2.48432253338E+00 2.50929038994E+00 2.53450917762E+00 2.55998141833E+00 2.58570965932E+00 2.61169647342E+00 2.63794445935E+00 2.66445624193E+00 2.69123447235E+00 2.71828182846E+00 2.74560101502E+00 2.77319476396E+00 2.80106583470E+00 2.82921701435E+00 2.85765111806E+00 2.88637098927E+00 2.91537949998E+00 2.94467955107E+00 2.97427407256E+00 3.00416602395E+00 3.03435839444E+00 3.06485420329E+00 3.09565650012E+00 3.12676836519E+00 3.15819290969E+00 3.18993327612E+00 3.22199263853E+00 3.25437420289E+00 3.28708120738E+00 3.32011692274E+00 3.35348465255E+00 3.38718773362E+00 3.42122953629E+00 3.45561346476E+00 3.49034295746E+00 3.52542148737E+00 3.56085256236E+00 3.59663972557E+00 3.63278655575E+00 3.66929666762E+00 3.70617371221E+00 3.74342137726E+00 3.78104338757E+00 3.81904350537E+00 3.85742553070E+00 3.89619330180E+00 3.93535069547E+00 3.97490162749E+00 4.01485005299E+00 4.05519996684E+00 4.09595540407E+00 4.13712044025E+00 4.17869919192E+00 4.22069581700E+00 4.26311451517E+00 4.30595952835E+00 4.34923514106E+00 4.39294568092E+00 4.43709551900E+00 4.48168907034E+00 4.52673079431E+00 4.57222519514E+00 4.61817682230E+00 4.66459027099E+00 4.71147018259E+00 4.75882124514E+00 4.80664819378E+00 4.85495581124E+00 4.90374892833E+00 4.95303242440E+00 5.00281122783E+00 5.05309031656E+00 5.10387471854E+00 5.15516951223E+00 5.20697982718E+00 5.25931084445E+00 5.31216779718E+00 5.36555597112E+00 5.41948070513E+00 5.47394739173E+00 5.52896147762E+00 5.58452846428E+00 5.64065390843E+00 5.69734342267E+00 5.75460267601E+00 5.81243739440E+00 5.87085336138E+00 5.92985641859E+00 5.98945246638E+00 6.04964746441E+00 6.11044743223E+00 6.17185844988E+00 6.23388665852E+00 6.29653826103E+00 6.35981952260E+00 6.42373677143E+00 6.48829639929E+00 6.55350486219E+00 6.61936868104E+00 6.68589444228E+00 6.75308879853E+00 6.82095846929E+00 6.88951024158E+00 6.95875097064E+00 7.02868758059E+00 7.09932706516E+00 7.17067648835E+00 7.24274298516E+00 7.31553376231E+00 7.38905609893E+00 7.46331734732E+00 7.53832493366E+00 7.61408635878E+00 7.69060919888E+00 7.76790110631E+00 7.84596981032E+00 7.92482311785E+00 8.00446891430E+00 8.08491516431E+00 8.16616991257E+00 8.24824128463E+00 8.33113748769E+00 8.41486681144E+00 8.49943762889E+00 8.58485839718E+00 8.67113765846E+00 8.75828404074E+00 8.84630625872E+00 8.93521311470E+00 9.02501349943E+00 9.11571639304E+00 9.20733086588E+00 9.29986607948E+00 9.39333128744E+00 9.48773583636E+00 9.58308916676E+00 9.67940081407E+00 9.77668040953E+00 9.87493768117E+00 9.97418245481E+00 1.00744246550E+01 1.01756743061E+01 1.02779415330E+01 1.03812365627E+01 1.04855697247E+01 1.05909514524E+01 1.06973922841E+01 1.08049028639E+01 1.09134939430E+01 1.10231763806E+01 1.11339611451E+01 1.12458593149E+01 1.13588820800E+01 1.14730407428E+01 1.15883467192E+01 1.17048115400E+01 1.18224468516E+01 1.19412644178E+01 1.20612761204E+01 1.21824939607E+01 1.23049300605E+01 1.24285966636E+01 1.25535061367E+01 1.26796709708E+01 1.28071037827E+01 1.29358173155E+01 1.30658244409E+01 1.31971381597E+01 1.33297716032E+01 1.34637380350E+01 1.35990508518E+01 1.37357235851E+01 1.38737699021E+01 1.40132036077E+01 1.41540386454E+01 1.42962890987E+01 1.44399691928E+01 1.45850932959E+01 1.47316759204E+01 1.48797317249E+01 1.50292755149E+01 1.51803222450E+01 1.53328870199E+01 1.54869850963E+01 1.56426318842E+01 1.57998429483E+01 1.59586340098E+01 1.61190209480E+01 1.62810198018E+01 1.64446467711E+01 1.66099182188E+01 1.67768506721E+01 1.69454608245E+01 1.71157655371E+01 1.72877818406E+01 1.74615269366E+01 1.76370181998E+01 1.78142731796E+01 1.79933096016E+01 1.81741453694E+01 1.83567985670E+01 1.85412874597E+01 1.87276304967E+01 1.89158463123E+01 1.91059537282E+01 1.92979717555E+01 1.94919195960E+01 1.96878166448E+01 1.98856824916E+01 2.00855369232E+01 2.02873999252E+01 2.04912916842E+01 2.06972325894E+01 2.09052432351E+01 2.11153444225E+01 2.13275571620E+01 2.15419026750E+01 2.17584023962E+01 2.19770779758E+01 2.21979512814E+01 2.24210444007E+01 2.26463796432E+01 2.28739795424E+01 2.31038668587E+01 2.33360645809E+01 2.35705959291E+01 2.38074843564E+01 2.40467535521E+01 2.42884274431E+01 2.45325301971E+01 2.47790862246E+01 2.50281201813E+01 2.52796569710E+01 2.55337217474E+01 2.57903399172E+01 2.60495371425E+01 2.63113393433E+01 2.65757726999E+01 2.68428636559E+01 2.71126389207E+01 2.73851254719E+01 2.76603505585E+01 2.79383417032E+01 2.82191267054E+01 2.85027336438E+01 2.87891908792E+01 2.90785270578E+01 2.93707711133E+01 2.96659522704E+01 2.99641000474E+01 3.02652442594E+01 3.05694150211E+01 3.08766427497E+01 3.11869581683E+01 3.15003923087E+01 3.18169765147E+01 3.21367424448E+01 3.24597220759E+01 3.27859477062E+01 3.31154519587E+01 3.34482677839E+01 3.37844284638E+01 3.41239676148E+01 3.44669191909E+01 3.48133174876E+01 3.51631971451E+01 3.55165931516E+01 3.58735408471E+01 3.62340759265E+01 3.65982344437E+01 3.69660528148E+01 3.73375678221E+01 3.77128166172E+01 3.80918367254E+01 3.84746660490E+01 3.88613428713E+01 3.92519058603E+01 3.96463940726E+01 4.00448469573E+01 4.04473043601E+01 4.08538065270E+01 4.12643941086E+01 4.16791081640E+01 4.20979901650E+01 4.25210820001E+01 4.29484259788E+01 4.33800648359E+01 4.38160417356E+01 4.42564002760E+01 4.47011844933E+01 4.51504388663E+01 4.56042083208E+01 4.60625382342E+01 4.65254744398E+01 4.69930632316E+01 4.74653513689E+01 4.79423860808E+01 4.84242150713E+01 4.89108865237E+01 4.94024491055E+01 4.98989519734E+01 5.04004447781E+01 5.09069776692E+01 5.14186013005E+01 5.19353668348E+01 5.24573259491E+01 5.29845308397E+01 5.35170342275E+01 5.40548893633E+01 5.45981500331E+01 5.51468705635E+01 5.57011058268E+01 5.62609112471E+01 5.68263428055E+01 5.73974570454E+01 5.79743110790E+01 5.85569625919E+01 5.91454698499E+01 5.97398917041E+01 6.03402875974E+01 6.09467175696E+01 6.15592422644E+01 6.21779229348E+01 6.28028214492E+01 6.34340002981E+01 6.40715225999E+01 6.47154521074E+01 6.53658532140E+01 6.60227909604E+01 6.66863310409E+01 6.73565398101E+01 6.80334842894E+01 6.87172321738E+01 6.94078518388E+01 7.01054123467E+01 7.08099834543E+01 7.15216356192E+01 7.22404400073E+01 7.29664684996E+01 7.36997936996E+01 7.44404889403E+01 7.51886282920E+01 7.59442865692E+01 7.67075393383E+01 7.74784629253E+01 7.82571344231E+01 7.90436316996E+01 7.98380334051E+01 8.06404189805E+01 8.14508686650E+01 8.22694635042E+01 8.30962853583E+01 8.39314169103E+01 8.47749416738E+01 8.56269440022E+01 8.64875090963E+01 8.73567230134E+01 8.82346726757E+01 8.91214458787E+01 9.00171313005E+01 9.09218185105E+01 9.18355979782E+01 9.27585610821E+01 9.36908001195E+01 9.46324083149E+01 9.55834798301E+01 9.65441097728E+01 9.75143942071E+01 9.84944301619E+01 9.94843156419E+01 2.47875217667E-05 2.50366405020E-05 2.52882629223E-05 2.55424141899E-05 2.57991197203E-05 2.60584051841E-05 2.63202965101E-05 2.65848198878E-05 2.68520017695E-05 2.71218688739E-05 2.73944481877E-05 2.76697669691E-05 2.79478527504E-05 2.82287333402E-05 2.85124368268E-05 2.87989915809E-05 2.90884262581E-05 2.93807698022E-05 2.96760514478E-05 2.99743007233E-05 3.02755474538E-05 3.05798217642E-05 3.08871540824E-05 3.11975751416E-05 3.15111159844E-05 3.18278079651E-05 3.21476827531E-05 3.24707723361E-05 3.27971090234E-05 3.31267254490E-05 3.34596545747E-05 3.37959296938E-05 3.41355844340E-05 3.44786527610E-05 3.48251689821E-05 3.51751677491E-05 3.55286840622E-05 3.58857532733E-05 3.62464110897E-05 3.66106935773E-05 3.69786371648E-05 3.73502786469E-05 3.77256551879E-05 3.81048043259E-05 3.84877639761E-05 3.88745724348E-05 3.92652683831E-05 3.96598908909E-05 4.00584794209E-05 4.04610738322E-05 4.08677143846E-05 4.12784417426E-05 4.16932969790E-05 4.21123215800E-05 4.25355574482E-05 4.29630469075E-05 4.33948327074E-05 4.38309580267E-05 4.42714664783E-05 4.47164021135E-05 4.51658094261E-05 4.56197333574E-05 4.60782192999E-05 4.65413131028E-05 4.70090610758E-05 4.74815099941E-05 4.79587071030E-05 4.84407001225E-05 4.89275372524E-05 4.94192671768E-05 4.99159390691E-05 5.04176025969E-05 5.09243079270E-05 5.14361057303E-05 5.19530471871E-05 5.24751839918E-05 5.30025683587E-05 5.35352530266E-05 5.40732912644E-05 5.46167368764E-05 5.51656442076E-05 5.57200681492E-05 5.62800641440E-05 5.68456881922E-05 5.74169968565E-05 5.79940472684E-05 5.85768971334E-05 5.91656047368E-05 5.97602289501E-05 6.03608292360E-05 6.09674656552E-05 6.15801988717E-05 6.21990901594E-05 6.28242014080E-05 6.34555951291E-05 6.40933344626E-05 6.47374831829E-05 6.53881057055E-05 6.60452670931E-05 6.67090330626E-05 6.73794699909E-05 6.80566449223E-05 6.87406255750E-05 6.94314803475E-05 7.01292783259E-05 7.08340892905E-05 7.15459837231E-05 7.22650328138E-05 7.29913084679E-05 7.37248833137E-05 7.44658307092E-05 7.52142247499E-05 7.59701402758E-05 7.67336528790E-05 7.75048389114E-05 7.82837754923E-05 7.90705405159E-05 7.98652126596E-05 8.06678713910E-05 8.14785969768E-05 8.22974704902E-05 8.31245738192E-05 8.39599896749E-05 8.48038015995E-05 8.56560939750E-05 8.65169520312E-05 8.73864618547E-05 8.82647103973E-05 8.91517854844E-05 9.00477758244E-05 9.09527710170E-05 9.18668615624E-05 9.27901388706E-05 9.37226952701E-05 9.46646240171E-05 9.56160193054E-05 9.65769762754E-05 9.75475910234E-05 9.85279606119E-05 9.95181830785E-05 1.00518357446E-04 1.01528583734E-04 1.02548962964E-04 1.03579597176E-04 1.04620589434E-04 1.05672043839E-04 1.06734065535E-04 1.07806760727E-04 1.08890236686E-04 1.09984601758E-04 1.11089965382E-04 1.12206438096E-04 1.13334131547E-04 1.14473158505E-04 1.15623632875E-04 1.16785669704E-04 1.17959385198E-04 1.19144896728E-04 1.20342322847E-04 1.21551783299E-04 1.22773399031E-04 1.24007292204E-04 1.25253586211E-04 1.26512405680E-04 1.27783876495E-04 1.29068125805E-04 1.30365282034E-04 1.31675474901E-04 1.32998835424E-04 1.34335495942E-04 1.35685590122E-04 1.37049252974E-04 1.38426620865E-04 1.39817831533E-04 1.41223024102E-04 1.42642339090E-04 1.44075918431E-04 1.45523905484E-04 1.46986445049E-04 1.48463683381E-04 1.49955768205E-04 1.51462848730E-04 1.52985075667E-04 1.54522601239E-04 1.56075579200E-04 1.57644164849E-04 1.59228515045E-04 1.60828788226E-04 1.62445144419E-04 1.64077745263E-04 1.65726754018E-04 1.67392335586E-04 1.69074656527E-04 1.70773885075E-04 1.72490191153E-04 1.74223746395E-04 1.75974724156E-04 1.77743299537E-04 1.79529649395E-04 1.81333952368E-04 1.83156388887E-04 1.84997141198E-04 1.86856393377E-04 1.88734331352E-04 1.90631142916E-04 1.92547017754E-04 1.94482147454E-04 1.96436725531E-04 1.98410947444E-04 2.00405010617E-04 2.02419114458E-04 2.04453460379E-04 2.06508251817E-04 2.08583694252E-04 2.10679995230E-04 2.12797364384E-04 2.14936013451E-04 2.17096156298E-04 2.19278008943E-04 2.21481789570E-04 2.23707718562E-04 2.25956018511E-04 2.28226914251E-04 2.30520632872E-04 2.32837403749E-04 2.35177458560E-04 2.37541031313E-04 2.39928358367E-04 2.42339678457E-04 2.44775232717E-04 2.47235264703E-04 2.49720020423E-04 2.52229748352E-04 2.54764699467E-04 2.57325127264E-04 2.59911287788E-04 2.62523439657E-04 2.65161844089E-04 2.67826764926E-04 2.70518468664E-04 2.73237224473E-04 2.75983304232E-04 2.78756982552E-04 2.81558536803E-04 2.84388247142E-04 2.87246396542E-04 2.90133270822E-04 2.93049158670E-04 2.95994351679E-04 2.98969144369E-04 3.01973834223E-04 3.05008721712E-04 3.08074110328E-04 3.11170306611E-04 3.14297620184E-04 3.17456363781E-04 3.20646853279E-04 3.23869407729E-04 3.27124349390E-04 3.30412003759E-04 3.33732699603E-04 3.37086768996E-04 3.40474547346E-04 3.43896373435E-04 3.47352589447E-04 3.50843541008E-04 3.54369577216E-04 3.57931050677E-04 3.61528317540E-04 3.65161737537E-04 3.68831674012E-04 3.72538493962E-04 3.76282568072E-04 3.80064270752E-04 3.83883980176E-04 3.87742078317E-04 3.91638950990E-04 3.95574987884E-04 3.99550582607E-04 4.03566132720E-04 4.07622039784E-04 4.11718709391E-04 4.15856551212E-04 4.20035979034E-04 4.24257410805E-04 4.28521268670E-04 4.32827979020E-04 4.37177972528E-04 4.41571684197E-04 4.46009553403E-04 4.50492023936E-04 4.55019544046E-04 4.59592566490E-04 4.64211548574E-04 4.68876952200E-04 4.73589243911E-04 4.78348894942E-04 4.83156381261E-04 4.88012183620E-04 4.92916787605E-04 4.97870683679E-04 5.02874367236E-04 5.07928338649E-04 5.13033103319E-04 5.18189171727E-04 5.23397059484E-04 5.28657287384E-04 5.33970381452E-04 5.39336873004E-04 5.44757298692E-04 5.50232200564E-04 5.55762126115E-04 5.61347628341E-04 5.66989265798E-04 5.72687602655E-04 5.78443208748E-04 5.84256659645E-04 5.90128536694E-04 5.96059427089E-04 6.02049923924E-04 6.08100626252E-04 6.14212139150E-04 6.20385073774E-04 6.26620047422E-04 6.32917683596E-04 6.39278612067E-04 6.45703468932E-04 6.52192896681E-04 6.58747544264E-04 6.65368067150E-04 6.72055127397E-04 6.78809393718E-04 6.85631541543E-04 6.92522253093E-04 6.99482217447E-04 7.06512130604E-04 7.13612695564E-04 7.20784622388E-04 7.28028628274E-04 7.35345437631E-04 7.42735782143E-04 7.50200400853E-04 7.57740040228E-04 7.65355454239E-04 7.73047404433E-04 7.80816660012E-04 7.88663997907E-04 7.96590202859E-04 8.04596067495E-04 8.12682392409E-04 8.20849986239E-04 8.29099665752E-04 8.37432255922E-04 8.45848590016E-04 8.54349509673E-04 8.62935864994E-04 8.71608514620E-04 8.80368325824E-04 8.89216174594E-04 8.98152945722E-04 9.07179532894E-04 9.16296838775E-04 9.25505775103E-04 9.34807262781E-04 9.44202231963E-04 9.53691622155E-04 9.63276382305E-04 9.72957470895E-04 9.82735856044E-04 9.92612515596E-04 1.00258843723E-03 1.01266461854E-03 1.02284206716E-03 1.03312180083E-03 1.04350484755E-03 1.05399224562E-03 1.06458504379E-03 1.07528430136E-03 1.08609108825E-03 1.09700648516E-03 1.10803158362E-03 1.11916748617E-03 1.13041530640E-03 1.14177616911E-03 1.15325121038E-03 1.16484157773E-03 1.17654843022E-03 1.18837293852E-03 1.20031628511E-03 1.21237966433E-03 1.22456428253E-03 1.23687135817E-03 1.24930212199E-03 1.26185781705E-03 1.27453969895E-03 1.28734903588E-03 1.30028710878E-03 1.31335521148E-03 1.32655465080E-03 1.33988674669E-03 1.35335283237E-03 1.36695425446E-03 1.38069237311E-03 1.39456856215E-03 1.40858420921E-03 1.42274071587E-03 1.43703949778E-03 1.45148198484E-03 1.46606962130E-03 1.48080386595E-03 1.49568619223E-03 1.51071808836E-03 1.52590105757E-03 1.54123661815E-03 1.55672630368E-03 1.57237166314E-03 1.58817426107E-03 1.60413567775E-03 1.62025750934E-03 1.63654136803E-03 1.65298888222E-03 1.66960169667E-03 1.68638147269E-03 1.70332988825E-03 1.72044863823E-03 1.73773943450E-03 1.75520400617E-03 1.77284409970E-03 1.79066147911E-03 1.80865792617E-03 1.82683524053E-03 1.84519523993E-03 1.86373976039E-03 1.88247065639E-03 1.90138980102E-03 1.92049908621E-03 1.93980042291E-03 1.95929574127E-03 1.97898699084E-03 1.99887614075E-03 2.01896517995E-03 2.03925611734E-03 2.05975098205E-03 2.08045182357E-03 2.10136071201E-03 2.12247973827E-03 2.14381101427E-03 2.16535667316E-03 2.18711886952E-03 2.20909977959E-03 2.23130160148E-03 2.25372655539E-03 2.27637688384E-03 2.29925485187E-03 2.32236274730E-03 2.34570288094E-03 2.36927758682E-03 2.39308922244E-03 2.41714016897E-03 2.44143283153E-03 2.46596963942E-03 2.49075304632E-03 2.51578553060E-03 2.54106959553E-03 2.56660776954E-03 2.59240260646E-03 2.61845668580E-03 2.64477261300E-03 2.67135301966E-03 2.69820056385E-03 2.72531793034E-03 2.75270783090E-03 2.78037300453E-03 2.80831621778E-03 2.83654026500E-03 2.86504796860E-03 2.89384217939E-03 2.92292577681E-03 2.95230166924E-03 2.98197279430E-03 3.01194211912E-03 3.04221264067E-03 3.07278738601E-03 3.10366941265E-03 3.13486180883E-03 3.16636769379E-03 3.19819021816E-03 3.23033256422E-03 3.26279794623E-03 3.29558961075E-03 3.32871083698E-03 3.36216493707E-03 3.39595525645E-03 3.43008517419E-03 3.46455810330E-03 3.49937749111E-03 3.53454681959E-03 3.57006960569E-03 3.60594940173E-03 3.64218979572E-03 3.67879441171E-03 3.71576691022E-03 3.75311098851E-03 3.79083038103E-03 3.82892885975E-03 3.86741023455E-03 3.90627835359E-03 3.94553710372E-03 3.98519041085E-03 4.02524224034E-03 4.06569659741E-03 4.10655752752E-03 4.14782911682E-03 4.18951549248E-03 4.23162082318E-03 4.27414931949E-03 4.31710523429E-03 4.36049286322E-03 4.40431654506E-03 4.44858066223E-03 4.49328964117E-03 4.53844795282E-03 4.58406011305E-03 4.63013068311E-03 4.67666427010E-03 4.72366552741E-03 4.77113915521E-03 4.81908990090E-03 4.86752255960E-03 4.91644197461E-03 4.96585303791E-03 5.01576069066E-03 5.06616992366E-03 5.11708577787E-03 5.16851334492E-03 5.22045776761E-03 5.27292424043E-03 5.32591801007E-03 5.37944437595E-03 5.43350869074E-03 5.48811636094E-03 5.54327284735E-03 5.59898366565E-03 5.65525438700E-03 5.71209063849E-03 5.76949810380E-03 5.82748252374E-03 5.88604969678E-03 5.94520547970E-03 6.00495578812E-03 6.06530659713E-03 6.12626394184E-03 6.18783391806E-03 6.25002268283E-03 6.31283645507E-03 6.37628151622E-03 6.44036421083E-03 6.50509094723E-03 6.57046819815E-03 6.63650250136E-03 6.70320046036E-03 6.77056874498E-03 6.83861409212E-03 6.90734330637E-03 6.97676326071E-03 7.04688089719E-03 7.11770322763E-03 7.18923733432E-03 7.26149037074E-03 7.33446956224E-03 7.40818220682E-03 7.48263567579E-03 7.55783741456E-03 7.63379494337E-03 7.71051585804E-03 7.78800783071E-03 7.86627861067E-03 7.94533602503E-03 8.02518797962E-03 8.10584245970E-03 8.18730753078E-03 8.26959133943E-03 8.35270211411E-03 8.43664816596E-03 8.52143788966E-03 8.60707976425E-03 8.69358235399E-03 8.78095430921E-03 8.86920436717E-03 8.95834135297E-03 9.04837418036E-03 9.13931185271E-03 9.23116346387E-03 9.32393819906E-03 9.41764533584E-03 9.51229424501E-03 9.60789439152E-03 9.70445533549E-03 9.80198673307E-03 9.90049833749E-03 1.00000000000E-02 1.01005016708E-02 1.02020134003E-02 1.03045453395E-02 1.04081077419E-02 1.05127109638E-02 1.06183654655E-02 1.07250818125E-02 1.08328706767E-02 1.09417428371E-02 1.10517091808E-02 1.11627807046E-02 1.12749685158E-02 1.13882838332E-02 1.15027379886E-02 1.16183424273E-02 1.17351087099E-02 1.18530485132E-02 1.19721736312E-02 1.20924959766E-02 1.22140275816E-02 1.23367805996E-02 1.24607673059E-02 1.25860000993E-02 1.27124915032E-02 1.28402541669E-02 1.29693008667E-02 1.30996445073E-02 1.32312981234E-02 1.33642748803E-02 1.34985880758E-02 1.36342511413E-02 1.37712776434E-02 1.39096812846E-02 1.40494759056E-02 1.41906754859E-02 1.43332941456E-02 1.44773461466E-02 1.46228458943E-02 1.47698079388E-02 1.49182469764E-02 1.50681778511E-02 1.52196155562E-02 1.53725752355E-02 1.55270721851E-02 1.56831218549E-02 1.58407398499E-02 1.59999419322E-02 1.61607440219E-02 1.63231621996E-02 1.64872127070E-02 1.66529119495E-02 1.68202764970E-02 1.69893230862E-02 1.71600686218E-02 1.73325301787E-02 1.75067250030E-02 1.76826705143E-02 1.78603843075E-02 1.80398841540E-02 1.82211880039E-02 1.84043139878E-02 1.85892804185E-02 1.87761057926E-02 1.89648087930E-02 1.91554082901E-02 1.93479233440E-02 1.95423732064E-02 1.97387773223E-02 1.99371553324E-02 2.01375270747E-02 2.03399125865E-02 2.05443321064E-02 2.07508060767E-02 2.09593551449E-02 2.11700001661E-02 2.13827622050E-02 2.15976625378E-02 2.18147226550E-02 2.20339642626E-02 2.22554092849E-02 2.24790798668E-02 2.27049983753E-02 2.29331874026E-02 2.31636697678E-02 2.33964685193E-02 2.36316069371E-02 2.38691085352E-02 2.41089970642E-02 2.43512965129E-02 2.45960311116E-02 2.48432253338E-02 2.50929038994E-02 2.53450917762E-02 2.55998141833E-02 2.58570965932E-02 2.61169647342E-02 2.63794445935E-02 2.66445624193E-02 2.69123447235E-02 2.71828182846E-02 2.74560101502E-02 2.77319476396E-02 2.80106583470E-02 2.82921701435E-02 2.85765111806E-02 2.88637098927E-02 2.91537949998E-02 2.94467955107E-02 2.97427407256E-02 3.00416602395E-02 3.03435839444E-02 3.06485420329E-02 3.09565650012E-02 3.12676836519E-02 3.15819290969E-02 3.18993327612E-02 3.22199263853E-02 3.25437420289E-02 3.28708120738E-02 3.32011692274E-02 3.35348465255E-02 3.38718773362E-02 3.42122953629E-02 3.45561346476E-02 3.49034295746E-02 3.52542148737E-02 3.56085256236E-02 3.59663972557E-02 3.63278655575E-02 3.66929666762E-02 3.70617371221E-02 3.74342137726E-02 3.78104338757E-02 3.81904350537E-02 3.85742553070E-02 3.89619330180E-02 3.93535069547E-02 3.97490162749E-02 4.01485005299E-02 4.05519996684E-02 4.09595540407E-02 4.13712044025E-02 4.17869919192E-02 4.22069581700E-02 4.26311451517E-02 4.30595952835E-02 4.34923514106E-02 4.39294568092E-02 4.43709551900E-02 4.48168907034E-02 4.52673079431E-02 4.57222519514E-02 4.61817682230E-02 4.66459027099E-02 4.71147018259E-02 4.75882124514E-02 4.80664819378E-02 4.85495581124E-02 4.90374892833E-02 4.95303242440E-02 5.00281122783E-02 5.05309031656E-02 5.10387471854E-02 5.15516951223E-02 5.20697982718E-02 5.25931084445E-02 5.31216779718E-02 5.36555597112E-02 5.41948070513E-02 5.47394739173E-02 5.52896147762E-02 5.58452846428E-02 5.64065390843E-02 5.69734342267E-02 5.75460267601E-02 5.81243739440E-02 5.87085336138E-02 5.92985641859E-02 5.98945246638E-02 6.04964746441E-02 6.11044743223E-02 6.17185844988E-02 6.23388665852E-02 6.29653826103E-02 6.35981952260E-02 6.42373677143E-02 6.48829639929E-02 6.55350486219E-02 6.61936868104E-02 6.68589444228E-02 6.75308879853E-02 6.82095846929E-02 6.88951024158E-02 6.95875097064E-02 7.02868758059E-02 7.09932706516E-02 7.17067648835E-02 7.24274298516E-02 7.31553376231E-02 7.38905609893E-02 7.46331734732E-02 7.53832493366E-02 7.61408635878E-02 7.69060919888E-02 7.76790110631E-02 7.84596981032E-02 7.92482311785E-02 8.00446891430E-02 8.08491516431E-02 8.16616991257E-02 8.24824128463E-02 8.33113748769E-02 8.41486681144E-02 8.49943762889E-02 8.58485839718E-02 8.67113765846E-02 8.75828404074E-02 8.84630625872E-02 8.93521311470E-02 9.02501349943E-02 9.11571639304E-02 9.20733086588E-02 9.29986607948E-02 9.39333128744E-02 9.48773583636E-02 9.58308916676E-02 9.67940081407E-02 9.77668040953E-02 9.87493768117E-02 9.97418245481E-02 1.00744246550E-01 1.01756743061E-01 1.02779415330E-01 1.03812365627E-01 1.04855697247E-01 1.05909514524E-01 1.06973922841E-01 1.08049028639E-01 1.09134939430E-01 1.10231763806E-01 1.11339611451E-01 1.12458593149E-01 1.13588820800E-01 1.14730407428E-01 1.15883467192E-01 1.17048115400E-01 1.18224468516E-01 1.19412644178E-01 1.20612761204E-01 1.21824939607E-01 1.23049300605E-01 1.24285966636E-01 1.25535061367E-01 1.26796709708E-01 1.28071037827E-01 1.29358173155E-01 1.30658244409E-01 1.31971381597E-01 1.33297716032E-01 1.34637380350E-01 1.35990508518E-01 1.37357235851E-01 1.38737699021E-01 1.40132036077E-01 1.41540386454E-01 1.42962890987E-01 1.44399691928E-01 1.45850932959E-01 1.47316759204E-01 1.48797317249E-01 1.50292755149E-01 1.51803222450E-01 1.53328870199E-01 1.54869850963E-01 1.56426318842E-01 1.57998429483E-01 1.59586340098E-01 1.61190209480E-01 1.62810198018E-01 1.64446467711E-01 1.66099182188E-01 1.67768506721E-01 1.69454608245E-01 1.71157655371E-01 1.72877818406E-01 1.74615269366E-01 1.76370181998E-01 1.78142731796E-01 1.79933096016E-01 1.81741453694E-01 1.83567985670E-01 1.85412874597E-01 1.87276304967E-01 1.89158463123E-01 1.91059537282E-01 1.92979717555E-01 1.94919195960E-01 1.96878166448E-01 1.98856824916E-01 2.00855369232E-01 2.02873999252E-01 2.04912916842E-01 2.06972325894E-01 2.09052432351E-01 2.11153444225E-01 2.13275571620E-01 2.15419026750E-01 2.17584023962E-01 2.19770779758E-01 2.21979512814E-01 2.24210444007E-01 2.26463796432E-01 2.28739795424E-01 2.31038668587E-01 2.33360645809E-01 2.35705959291E-01 2.38074843564E-01 2.40467535521E-01 2.42884274431E-01 2.45325301971E-01 2.47790862246E-01 2.50281201813E-01 2.52796569710E-01 2.55337217474E-01 2.57903399172E-01 2.60495371425E-01 2.63113393433E-01 2.65757726999E-01 2.68428636559E-01 2.71126389207E-01 2.73851254719E-01 2.76603505585E-01 2.79383417032E-01 2.82191267054E-01 2.85027336438E-01 2.87891908792E-01 2.90785270578E-01 2.93707711133E-01 2.96659522704E-01 2.99641000474E-01 3.02652442594E-01 3.05694150211E-01 3.08766427497E-01 3.11869581683E-01 3.15003923087E-01 3.18169765147E-01 3.21367424448E-01 3.24597220759E-01 3.27859477062E-01 3.31154519587E-01 3.34482677839E-01 3.37844284638E-01 3.41239676148E-01 3.44669191909E-01 3.48133174876E-01 3.51631971451E-01 3.55165931516E-01 3.58735408471E-01 3.62340759265E-01 3.65982344437E-01 3.69660528148E-01 3.73375678221E-01 3.77128166172E-01 3.80918367254E-01 3.84746660490E-01 3.88613428713E-01 3.92519058603E-01 3.96463940726E-01 4.00448469573E-01 4.04473043601E-01 4.08538065270E-01 4.12643941086E-01 4.16791081640E-01 4.20979901650E-01 4.25210820001E-01 4.29484259788E-01 4.33800648359E-01 4.38160417356E-01 4.42564002760E-01 4.47011844933E-01 4.51504388663E-01 4.56042083208E-01 4.60625382342E-01 4.65254744398E-01 4.69930632316E-01 4.74653513689E-01 4.79423860808E-01 4.84242150713E-01 4.89108865237E-01 4.94024491055E-01 4.98989519734E-01 5.04004447781E-01 5.09069776692E-01 5.14186013005E-01 5.19353668348E-01 5.24573259491E-01 5.29845308397E-01 5.35170342275E-01 5.40548893633E-01 5.45981500331E-01 5.51468705635E-01 5.57011058268E-01 5.62609112471E-01 5.68263428055E-01 5.73974570454E-01 5.79743110790E-01 5.85569625919E-01 5.91454698499E-01 5.97398917041E-01 6.03402875974E-01 6.09467175696E-01 6.15592422644E-01 6.21779229348E-01 6.28028214492E-01 6.34340002981E-01 6.40715225999E-01 6.47154521074E-01 6.53658532140E-01 6.60227909604E-01 6.66863310409E-01 6.73565398101E-01 6.80334842894E-01 6.87172321738E-01 6.94078518388E-01 7.01054123467E-01 7.08099834543E-01 7.15216356192E-01 7.22404400073E-01 7.29664684996E-01 7.36997936996E-01 7.44404889403E-01 7.51886282920E-01 7.59442865692E-01 7.67075393383E-01 7.74784629253E-01 7.82571344231E-01 7.90436316996E-01 7.98380334051E-01 8.06404189805E-01 8.14508686650E-01 8.22694635042E-01 8.30962853583E-01 8.39314169103E-01 8.47749416738E-01 8.56269440022E-01 8.64875090963E-01 8.73567230134E-01 8.82346726757E-01 8.91214458787E-01 9.00171313005E-01 9.09218185105E-01 9.18355979782E-01 9.27585610821E-01 9.36908001195E-01 9.46324083149E-01 9.55834798301E-01 9.65441097728E-01 9.75143942071E-01 9.84944301619E-01 9.94843156419E-01 -4.91188828404E+00 -4.91188830693E+00 -4.91188833028E+00 -4.91188835410E+00 -4.91188837840E+00 -4.91188840319E+00 -4.91188842848E+00 -4.91188845428E+00 -4.91188848060E+00 -4.91188850745E+00 -4.91188853485E+00 -4.91188856279E+00 -4.91188859130E+00 -4.91188862039E+00 -4.91188865006E+00 -4.91188868033E+00 -4.91188871121E+00 -4.91188874271E+00 -4.91188877485E+00 -4.91188880763E+00 -4.91188884108E+00 -4.91188887520E+00 -4.91188891001E+00 -4.91188894552E+00 -4.91188898174E+00 -4.91188901870E+00 -4.91188905640E+00 -4.91188909486E+00 -4.91188913409E+00 -4.91188917412E+00 -4.91188921495E+00 -4.91188925660E+00 -4.91188929910E+00 -4.91188934245E+00 -4.91188938667E+00 -4.91188943178E+00 -4.91188947781E+00 -4.91188952476E+00 -4.91188957265E+00 -4.91188962151E+00 -4.91188967135E+00 -4.91188972220E+00 -4.91188977407E+00 -4.91188982699E+00 -4.91188988097E+00 -4.91188993603E+00 -4.91188999221E+00 -4.91189004952E+00 -4.91189010797E+00 -4.91189016761E+00 -4.91189022845E+00 -4.91189029051E+00 -4.91189035382E+00 -4.91189041840E+00 -4.91189048428E+00 -4.91189055149E+00 -4.91189062005E+00 -4.91189068998E+00 -4.91189076133E+00 -4.91189083410E+00 -4.91189090835E+00 -4.91189098408E+00 -4.91189106134E+00 -4.91189114015E+00 -4.91189122054E+00 -4.91189130255E+00 -4.91189138620E+00 -4.91189147154E+00 -4.91189155859E+00 -4.91189164739E+00 -4.91189173798E+00 -4.91189183038E+00 -4.91189192464E+00 -4.91189202079E+00 -4.91189211887E+00 -4.91189221892E+00 -4.91189232097E+00 -4.91189242508E+00 -4.91189253127E+00 -4.91189263960E+00 -4.91189275009E+00 -4.91189286281E+00 -4.91189297778E+00 -4.91189309506E+00 -4.91189321469E+00 -4.91189333671E+00 -4.91189346118E+00 -4.91189358815E+00 -4.91189371766E+00 -4.91189384976E+00 -4.91189398451E+00 -4.91189412196E+00 -4.91189426216E+00 -4.91189440516E+00 -4.91189455103E+00 -4.91189469981E+00 -4.91189485157E+00 -4.91189500637E+00 -4.91189516426E+00 -4.91189532531E+00 -4.91189548958E+00 -4.91189565712E+00 -4.91189582802E+00 -4.91189600233E+00 -4.91189618012E+00 -4.91189636146E+00 -4.91189654642E+00 -4.91189673507E+00 -4.91189692748E+00 -4.91189712373E+00 -4.91189732390E+00 -4.91189752805E+00 -4.91189773627E+00 -4.91189794864E+00 -4.91189816524E+00 -4.91189838615E+00 -4.91189861146E+00 -4.91189884126E+00 -4.91189907562E+00 -4.91189931464E+00 -4.91189955842E+00 -4.91189980704E+00 -4.91190006060E+00 -4.91190031920E+00 -4.91190058293E+00 -4.91190085189E+00 -4.91190112619E+00 -4.91190140593E+00 -4.91190169121E+00 -4.91190198214E+00 -4.91190227884E+00 -4.91190258142E+00 -4.91190288998E+00 -4.91190320464E+00 -4.91190352553E+00 -4.91190385276E+00 -4.91190418645E+00 -4.91190452674E+00 -4.91190487374E+00 -4.91190522758E+00 -4.91190558840E+00 -4.91190595634E+00 -4.91190633152E+00 -4.91190671408E+00 -4.91190710418E+00 -4.91190750194E+00 -4.91190790752E+00 -4.91190832107E+00 -4.91190874274E+00 -4.91190917269E+00 -4.91190961106E+00 -4.91191005802E+00 -4.91191051373E+00 -4.91191097837E+00 -4.91191145209E+00 -4.91191193506E+00 -4.91191242747E+00 -4.91191292949E+00 -4.91191344130E+00 -4.91191396308E+00 -4.91191449503E+00 -4.91191503732E+00 -4.91191559016E+00 -4.91191615373E+00 -4.91191672824E+00 -4.91191731389E+00 -4.91191791089E+00 -4.91191851945E+00 -4.91191913977E+00 -4.91191977209E+00 -4.91192041660E+00 -4.91192107355E+00 -4.91192174315E+00 -4.91192242564E+00 -4.91192312125E+00 -4.91192383022E+00 -4.91192455278E+00 -4.91192528920E+00 -4.91192603971E+00 -4.91192680456E+00 -4.91192758402E+00 -4.91192837834E+00 -4.91192918780E+00 -4.91193001265E+00 -4.91193085317E+00 -4.91193170963E+00 -4.91193258232E+00 -4.91193347152E+00 -4.91193437751E+00 -4.91193530059E+00 -4.91193624106E+00 -4.91193719921E+00 -4.91193817535E+00 -4.91193916979E+00 -4.91194018283E+00 -4.91194121479E+00 -4.91194226599E+00 -4.91194333676E+00 -4.91194442742E+00 -4.91194553830E+00 -4.91194666974E+00 -4.91194782208E+00 -4.91194899565E+00 -4.91195019080E+00 -4.91195140789E+00 -4.91195264727E+00 -4.91195390929E+00 -4.91195519431E+00 -4.91195650269E+00 -4.91195783481E+00 -4.91195919103E+00 -4.91196057172E+00 -4.91196197726E+00 -4.91196340803E+00 -4.91196486440E+00 -4.91196634676E+00 -4.91196785550E+00 -4.91196939100E+00 -4.91197095365E+00 -4.91197254385E+00 -4.91197416198E+00 -4.91197580843E+00 -4.91197748361E+00 -4.91197918791E+00 -4.91198092172E+00 -4.91198268544E+00 -4.91198447947E+00 -4.91198630420E+00 -4.91198816002E+00 -4.91199004733E+00 -4.91199196653E+00 -4.91199391799E+00 -4.91199590211E+00 -4.91199791926E+00 -4.91199996984E+00 -4.91200205422E+00 -4.91200417277E+00 -4.91200632586E+00 -4.91200851384E+00 -4.91201073708E+00 -4.91201299591E+00 -4.91201529069E+00 -4.91201762174E+00 -4.91201998939E+00 -4.91202239394E+00 -4.91202483570E+00 -4.91202731495E+00 -4.91202983198E+00 -4.91203238703E+00 -4.91203498037E+00 -4.91203761222E+00 -4.91204028279E+00 -4.91204299228E+00 -4.91204574086E+00 -4.91204852868E+00 -4.91205135588E+00 -4.91205422257E+00 -4.91205712881E+00 -4.91206007466E+00 -4.91206306015E+00 -4.91206608527E+00 -4.91206914998E+00 -4.91207225420E+00 -4.91207539782E+00 -4.91207858068E+00 -4.91208180260E+00 -4.91208506333E+00 -4.91208836259E+00 -4.91209170005E+00 -4.91209507532E+00 -4.91209848796E+00 -4.91210193747E+00 -4.91210542330E+00 -4.91210894482E+00 -4.91211250134E+00 -4.91211609210E+00 -4.91211971627E+00 -4.91212337292E+00 -4.91212706106E+00 -4.91213077960E+00 -4.91213452736E+00 -4.91213830308E+00 -4.91214210537E+00 -4.91214593276E+00 -4.91214978364E+00 -4.91215365632E+00 -4.91215754895E+00 -4.91216145958E+00 -4.91216538610E+00 -4.91216932627E+00 -4.91217327771E+00 -4.91217723787E+00 -4.91218120404E+00 -4.91218517334E+00 -4.91218914271E+00 -4.91219310890E+00 -4.91219706846E+00 -4.91220101775E+00 -4.91220495290E+00 -4.91220886981E+00 -4.91221276416E+00 -4.91221663136E+00 -4.91222046658E+00 -4.91222426471E+00 -4.91222802036E+00 -4.91223172784E+00 -4.91223538117E+00 -4.91223897401E+00 -4.91224249970E+00 -4.91224595125E+00 -4.91224932126E+00 -4.91225260196E+00 -4.91225578519E+00 -4.91225886234E+00 -4.91226182439E+00 -4.91226466184E+00 -4.91226736472E+00 -4.91226992255E+00 -4.91227232433E+00 -4.91227455852E+00 -4.91227661300E+00 -4.91227847506E+00 -4.91228013135E+00 -4.91228156791E+00 -4.91228277007E+00 -4.91228372247E+00 -4.91228440899E+00 -4.91228481278E+00 -4.91228491615E+00 -4.91228470060E+00 -4.91228414675E+00 -4.91228323430E+00 -4.91228194201E+00 -4.91228024766E+00 -4.91227812797E+00 -4.91227555863E+00 -4.91227251416E+00 -4.91226896795E+00 -4.91226489215E+00 -4.91226025766E+00 -4.91225503403E+00 -4.91224918945E+00 -4.91224269068E+00 -4.91223550298E+00 -4.91222759003E+00 -4.91221891390E+00 -4.91220943499E+00 -4.91219911191E+00 -4.91218790143E+00 -4.91217575844E+00 -4.91216263580E+00 -4.91214848433E+00 -4.91213325267E+00 -4.91211688722E+00 -4.91209933204E+00 -4.91208052875E+00 -4.91206041644E+00 -4.91203893153E+00 -4.91201600775E+00 -4.91199157590E+00 -4.91196556385E+00 -4.91193789636E+00 -4.91190849495E+00 -4.91187727780E+00 -4.91184415959E+00 -4.91180905137E+00 -4.91177186041E+00 -4.91173249004E+00 -4.91169083951E+00 -4.91164680382E+00 -4.91160027352E+00 -4.91155113457E+00 -4.91149926816E+00 -4.91144455046E+00 -4.91138685251E+00 -4.91132603994E+00 -4.91126197277E+00 -4.91119450525E+00 -4.91112348552E+00 -4.91104875548E+00 -4.91097015047E+00 -4.91088749904E+00 -4.91080062270E+00 -4.91070933558E+00 -4.91061344423E+00 -4.91051274724E+00 -4.91040703501E+00 -4.91029608935E+00 -4.91017968320E+00 -4.91005758028E+00 -4.90992953472E+00 -4.90979529068E+00 -4.90965458200E+00 -4.90950713178E+00 -4.90935265196E+00 -4.90919084292E+00 -4.90902139302E+00 -4.90884397813E+00 -4.90865826118E+00 -4.90846389168E+00 -4.90826050516E+00 -4.90804772270E+00 -4.90782515033E+00 -4.90759237854E+00 -4.90734898161E+00 -4.90709451708E+00 -4.90682852507E+00 -4.90655052769E+00 -4.90626002831E+00 -4.90595651092E+00 -4.90563943939E+00 -4.90530825674E+00 -4.90496238437E+00 -4.90460122128E+00 -4.90422414325E+00 -4.90383050203E+00 -4.90341962439E+00 -4.90299081134E+00 -4.90254333709E+00 -4.90207644818E+00 -4.90158936246E+00 -4.90108126806E+00 -4.90055132237E+00 -4.89999865096E+00 -4.89942234643E+00 -4.89882146732E+00 -4.89819503687E+00 -4.89754204185E+00 -4.89686143127E+00 -4.89615211511E+00 -4.89541296301E+00 -4.89464280288E+00 -4.89384041947E+00 -4.89300455302E+00 -4.89213389767E+00 -4.89122710001E+00 -4.89028275750E+00 -4.88929941684E+00 -4.88827557239E+00 -4.88720966440E+00 -4.88610007735E+00 -4.88494513813E+00 -4.88374311428E+00 -4.88249221209E+00 -4.88119057472E+00 -4.87983628027E+00 -4.87842733977E+00 -4.87696169519E+00 -4.87543721737E+00 -4.87385170390E+00 -4.87220287699E+00 -4.87048838129E+00 -4.86870578164E+00 -4.86685256087E+00 -4.86492611747E+00 -4.86292376326E+00 -4.86084272105E+00 -4.85868012228E+00 -4.85643300454E+00 -4.85409830920E+00 -4.85167287892E+00 -4.84915345519E+00 -4.84653667581E+00 -4.84381907242E+00 -4.84099706799E+00 -4.83806697429E+00 -4.83502498940E+00 -4.83186719518E+00 -4.82858955486E+00 -4.82518791049E+00 -4.82165798055E+00 -4.81799535756E+00 -4.81419550570E+00 -4.81025375850E+00 -4.80616531663E+00 -4.80192524569E+00 -4.79752847415E+00 -4.79296979134E+00 -4.78824384555E+00 -4.78334514226E+00 -4.77826804251E+00 -4.77300676140E+00 -4.76755536672E+00 -4.76190777786E+00 -4.75605776480E+00 -4.74999894735E+00 -4.74372479471E+00 -4.73722862513E+00 -4.73050360596E+00 -4.72354275397E+00 -4.71633893598E+00 -4.70888486983E+00 -4.70117312576E+00 -4.69319612817E+00 -4.68494615775E+00 -4.67641535423E+00 -4.66759571942E+00 -4.65847912096E+00 -4.64905729647E+00 -4.63932185843E+00 -4.62926429959E+00 -4.61887599914E+00 -4.60814822948E+00 -4.59707216383E+00 -4.58563888462E+00 -4.57383939268E+00 -4.56166461734E+00 -4.54910542741E+00 -4.53615264322E+00 -4.52279704961E+00 -4.50902940996E+00 -4.49484048145E+00 -4.48022103137E+00 -4.46516185470E+00 -4.44965379294E+00 -4.43368775428E+00 -4.41725473507E+00 -4.40034584279E+00 -4.38295232039E+00 -4.36506557217E+00 -4.34667719123E+00 -4.32777898848E+00 -4.30836302325E+00 -4.28842163564E+00 -4.26794748047E+00 -4.24693356305E+00 -4.22537327659E+00 -4.20326044144E+00 -4.18058934608E+00 -4.15735478986E+00 -4.13355212754E+00 -4.10917731549E+00 -4.08422695975E+00 -4.05869836561E+00 -4.03258958893E+00 -4.00589948893E+00 -3.97862778255E+00 -3.95077510009E+00 -3.92234304215E+00 -3.89333423767E+00 -3.86375240289E+00 -3.83360240115E+00 -3.80289030311E+00 -3.77162344736E+00 -3.73981050100E+00 -3.70746151996E+00 -3.67458800866E+00 -3.64120297864E+00 -3.60732100579E+00 -3.57295828560E+00 -3.53813268600E+00 -3.50286379720E+00 -3.46717297793E+00 -3.43108339731E+00 -3.39462007180E+00 -3.35780989621E+00 -3.32068166815E+00 -3.28326610480E+00 -3.24559585116E+00 -3.20770547860E+00 -3.16963147274E+00 -3.13141220932E+00 -3.09308791687E+00 -3.05470062488E+00 -3.01629409598E+00 -2.97791374087E+00 -2.93960651421E+00 -2.90142079024E+00 -2.86340621631E+00 -2.82561354282E+00 -2.78809442803E+00 -2.75090121595E+00 -2.71408668604E+00 -2.67770377308E+00 -2.64180525588E+00 -2.60644341374E+00 -2.57166964965E+00 -2.53753407953E+00 -2.50408508723E+00 -2.47136884541E+00 -2.43942880299E+00 -2.40830514053E+00 -2.37803419576E+00 -2.34864786232E+00 -2.32017296622E+00 -2.29263062558E+00 -2.26603560113E+00 -2.24039564666E+00 -2.21571087101E+00 -2.19197312574E+00 -2.16916543558E+00 -2.14726149241E+00 -2.12622523736E+00 -2.10601056055E+00 -2.08656115298E+00 -2.06781055131E+00 -2.04968242342E+00 -2.03209115011E+00 -2.01494276777E+00 -1.99813634683E+00 -1.98156589231E+00 -1.96512286642E+00 -1.94869944746E+00 -1.93219265667E+00 -1.91550950351E+00 -1.89857332167E+00 -1.88133149244E+00 -1.86376477984E+00 -1.84589853343E+00 -1.82781604980E+00 -1.80967442403E+00 -1.79166786265E+00 -1.77384046917E+00 -1.75619046081E+00 -1.73871607255E+00 -1.72141555691E+00 -1.70428718380E+00 -1.68732924036E+00 -1.67054003076E+00 -1.65391787605E+00 -1.63746111398E+00 -1.62116809883E+00 -1.60503720128E+00 -1.58906680819E+00 -1.57325532251E+00 -1.55760116303E+00 -1.54210276432E+00 -1.52675857649E+00 -1.51156706510E+00 -1.49652671096E+00 -1.48163600999E+00 -1.46689347310E+00 -1.45229762599E+00 -1.43784700903E+00 -1.42354017714E+00 -1.40937569959E+00 -1.39535215990E+00 -1.38146815568E+00 -1.36772229848E+00 -1.35411321369E+00 -1.34063954036E+00 -1.32729993108E+00 -1.31409305186E+00 -1.30101758196E+00 -1.28807221380E+00 -1.27525565280E+00 -1.26256661727E+00 -1.25000383827E+00 -1.23756605947E+00 -1.22525203706E+00 -1.21306053959E+00 -1.20099034787E+00 -1.18904025484E+00 -1.17720906545E+00 -1.16549559654E+00 -1.15389867672E+00 -1.14241714624E+00 -1.13104985692E+00 -1.11979567198E+00 -1.10865346596E+00 -1.09762212458E+00 -1.08670054468E+00 -1.07588763404E+00 -1.06518231133E+00 -1.05458350597E+00 -1.04409015802E+00 -1.03370121812E+00 -1.02341564730E+00 -1.01323241696E+00 -1.00315063813E+00 -9.93169173714E-01 -9.83287025600E-01 -9.73503205591E-01 -9.63816735326E-01 -9.54226646179E-01 -9.44731979160E-01 -9.35331784823E-01 -9.26025123167E-01 -9.16811063544E-01 -9.07688684565E-01 -8.98657074011E-01 -8.89715328737E-01 -8.80862554584E-01 -8.72097866292E-01 -8.63420387405E-01 -8.54829250192E-01 -8.46323595551E-01 -8.37902572932E-01 -8.29565340246E-01 -8.21311063780E-01 -8.13138918121E-01 -8.05048086064E-01 -7.97037758538E-01 -7.89107134520E-01 -7.81255420958E-01 -7.73481832690E-01 -7.65785592367E-01 -7.58165930373E-01 -7.50622084749E-01 -7.43153301120E-01 -7.35758832614E-01 -7.28437939791E-01 -7.21189890569E-01 -7.14013960149E-01 -7.06909430942E-01 -6.99875592503E-01 -6.92911741452E-01 -6.86017181409E-01 -6.79191222921E-01 -6.72433183398E-01 -6.65742387039E-01 -6.59118164768E-01 -6.52559854166E-01 -6.46066799405E-01 -6.39638351182E-01 -6.33273866655E-01 -6.26972709378E-01 -6.20734249236E-01 -6.14557862387E-01 -6.08442931192E-01 -6.02388844161E-01 -5.96394995886E-01 -5.90460786984E-01 -5.84585624035E-01 -5.78768919524E-01 -5.73010091781E-01 -5.67308564924E-01 -5.61663768802E-01 -5.56075138936E-01 -5.50542116463E-01 -5.45064148082E-01 -5.39640685997E-01 -5.34271187863E-01 -5.28955116729E-01 -5.23691940990E-01 -5.18481134330E-01 -5.13322175667E-01 -5.08214549106E-01 -5.03157743887E-01 -4.98151254329E-01 -4.93194579784E-01 -4.88287224586E-01 -4.83428698000E-01 -4.78618514175E-01 -4.73856192093E-01 -4.69141255524E-01 -4.64473232974E-01 -4.59851657645E-01 -4.55276067379E-01 -4.50746004618E-01 -4.46261016360E-01 -4.41820654106E-01 -4.37424473823E-01 -4.33072035895E-01 -4.28762905079E-01 -4.24496650466E-01 -4.20272845433E-01 -4.16091067601E-01 -4.11950898796E-01 -4.07851925004E-01 -4.03793736330E-01 -3.99775926959E-01 -3.95798095113E-01 -3.91859843013E-01 -3.87960776837E-01 -3.84100506681E-01 -3.80278646524E-01 -3.76494814183E-01 -3.72748631278E-01 -3.69039723196E-01 -3.65367719051E-01 -3.61732251647E-01 -3.58132957441E-01 -3.54569476510E-01 -3.51041452509E-01 -3.47548532642E-01 -3.44090367622E-01 -3.40666611638E-01 -3.37276922319E-01 -3.33920960702E-01 -3.30598391197E-01 -3.27308881553E-01 -3.24052102824E-01 -3.20827729339E-01 -3.17635438665E-01 -3.14474911581E-01 -3.11345832040E-01 -3.08247887140E-01 -3.05180767093E-01 -3.02144165193E-01 -2.99137777786E-01 -2.96161304241E-01 -2.93214446917E-01 -2.90296911134E-01 -2.87408405145E-01 -2.84548640106E-01 -2.81717330048E-01 -2.78914191845E-01 -2.76138945192E-01 -2.73391312569E-01 -2.70671019219E-01 -2.67977793121E-01 -2.65311364958E-01 -2.62671468093E-01 -2.60057838543E-01 -2.57470214951E-01 -2.54908338561E-01 -2.52371953191E-01 -2.49860805209E-01 -2.47374643506E-01 -2.44913219472E-01 -2.42476286968E-01 -2.40063602309E-01 -2.37674924229E-01 -2.35310013868E-01 -2.32968634738E-01 -2.30650552706E-01 -2.28355535970E-01 -2.26083355031E-01 -2.23833782675E-01 -2.21606593950E-01 -2.19401566141E-01 -2.17218478747E-01 -2.15057113464E-01 -2.12917254159E-01 -2.10798686848E-01 -2.08701199677E-01 -2.06624582901E-01 -2.04568628859E-01 -2.02533131958E-01 -2.00517888651E-01 -1.98522697414E-01 -1.96547358729E-01 -1.94591675065E-01 -1.92655450852E-01 -1.90738492470E-01 -1.88840608224E-01 -1.86961608323E-01 -1.85101304869E-01 -1.83259511831E-01 -1.81436045030E-01 -1.79630722116E-01 -1.77843362558E-01 -1.76073787618E-01 -1.74321820338E-01 -1.72587285519E-01 -1.70870009705E-01 -1.69169821168E-01 -1.67486549886E-01 -1.65820027531E-01 -1.64170087446E-01 -1.62536564637E-01 -1.60919295747E-01 -1.59318119048E-01 -1.57732874418E-01 -1.56163403330E-01 -1.54609548834E-01 -1.53071155541E-01 -1.51548069609E-01 -1.50040138724E-01 -1.48547212092E-01 -1.47069140414E-01 -1.45605775882E-01 -1.44156972154E-01 -1.42722584346E-01 -1.41302469017E-01 -1.39896484149E-01 -1.38504489142E-01 -1.37126344792E-01 -1.35761913281E-01 -1.34411058161E-01 -1.33073644343E-01 -1.31749538083E-01 -1.30438606965E-01 -1.29140719893E-01 -1.27855747072E-01 -1.26583560006E-01 -1.25324031470E-01 -1.24077035508E-01 -1.22842447415E-01 -1.21620143731E-01 -1.20410002220E-01 -1.19211901866E-01 -1.18025722855E-01 -1.16851346567E-01 -1.15688654360E-01 -1.14537532474E-01 -1.13397864472E-01 -1.12269536385E-01 -1.11152435377E-01 -1.10046449736E-01 -1.08951468861E-01 -1.07867383252E-01 -1.06794084498E-01 -1.05731465268E-01 -1.04679419297E-01 -1.03637837230E-01 -1.02606623520E-01 -1.01585670557E-01 -1.00574876247E-01 -9.95741395073E-02 -9.85833602649E-02 -9.76024394407E-02 -9.66312789418E-02 -9.56697816513E-02 -9.47178514187E-02 -9.37753930502E-02 -9.28423122991E-02 -9.19185158566E-02 -9.10039113423E-02 -9.00984072949E-02 -8.92019131634E-02 -8.83143392976E-02 -8.74355969392E-02 -8.65655982134E-02 -8.57042561196E-02 -8.48514845228E-02 -8.40071981452E-02 -8.31713125574E-02 -8.23437441701E-02 -8.15244102259E-02 -8.07132287907E-02 -7.99101187456E-02 -7.91149997789E-02 -7.83277923782E-02 -7.75484178220E-02 -7.67767981721E-02 -7.60128562661E-02 -7.52565157091E-02 -7.45077008663E-02 -7.37663368557E-02 -7.30323495403E-02 -7.23056655207E-02 -7.15862121279E-02 -7.08739174159E-02 -7.01687101548E-02 -6.94705198231E-02 -6.87792766014E-02 -6.80949113646E-02 -6.74173556757E-02 -6.67465417785E-02 -6.60824025911E-02 -6.54248716991E-02 -6.47738833488E-02 -6.41293724407E-02 -6.34912745234E-02 -6.28595257864E-02 -6.22340630544E-02 -6.16148237805E-02 -6.10017460404E-02 -6.03947685257E-02 -5.97938305382E-02 -5.91988719835E-02 -5.86098333654E-02 -5.80266557795E-02 -5.74492809075E-02 -5.68776510115E-02 -5.63117089280E-02 -5.57513980623E-02 -5.51966623829E-02 -5.46474464157E-02 -5.41036952386E-02 -5.35653544762E-02 -5.30323702939E-02 -5.25046893928E-02 -5.19822590044E-02 -5.14650268852E-02 -5.09529413116E-02 -5.04459510746E-02 -4.99440054747E-02 -4.94470543170E-02 -4.89550479059E-02 -4.84679370405E-02 -4.79856730091E-02 -4.75082075850E-02 -4.70354930212E-02 -4.65674820460E-02 -4.61041278577E-02 -4.56453841207E-02 -4.51912049601E-02 -4.47415449577E-02 -4.42963591470E-02 -4.38556030092E-02 -4.34192324682E-02 -4.29872038867E-02 -4.25594740614E-02 -4.21360002189E-02 -4.17167400116E-02 -4.13016515130E-02 -4.08906932140E-02 -4.04838240184E-02 -4.00810032390E-02 -3.96821905933E-02 -3.92873461997E-02 -3.88964305734E-02 -3.85094046227E-02 -3.81262296444E-02 -3.77468673210E-02 -3.73712797157E-02 -3.69994292695E-02 -3.66312787971E-02 -3.62667914831E-02 -3.59059308784E-02 -3.55486608968E-02 -3.51949458109E-02 -3.48447502489E-02 -3.44980391909E-02 -3.41547779656E-02 -3.38149322466E-02 -3.34784680490E-02 -3.31453517261E-02 -3.28155499660E-02 -3.24890297882E-02 -3.21657585405E-02 -3.18457038954E-02 -3.15288338473E-02 -3.12151167088E-02 -3.09045211080E-02 -3.05970159851E-02 -3.02925705893E-02 -2.99911544757E-02 -2.96927375027E-02 -2.93972898281E-02 -2.91047819069E-02 -2.88151844883E-02 -2.85284686121E-02 -2.82446056065E-02 -2.79635670850E-02 -2.76853249436E-02 -2.74098513577E-02 -2.71371187797E-02 -2.68670999363E-02 -2.65997678253E-02 -2.63350957132E-02 -2.60730571326E-02 -2.58136258795E-02 -2.55567760104E-02 -2.53024818403E-02 -2.50507179394E-02 -2.48014591312E-02 -2.45546804896E-02 -2.43103573365E-02 -2.40684652394E-02 -2.38289800088E-02 -2.35918776962E-02 -2.33571345909E-02 -2.31247272186E-02 -2.28946323383E-02 -2.26668269403E-02 -2.24412882438E-02 -2.22179936949E-02 -2.19969209639E-02 -2.17780479433E-02 -2.15613527456E-02 -2.13468137012E-02 -2.11344093560E-02 -2.09241184693E-02 -2.07159200118E-02 -2.05097931637E-02 -2.03057173119E-02 -2.01036720488E-02 1 0 Beta L 629 -1.36425633878E+00 -1.37796536855E+00 -1.39181211623E+00 -1.40579796408E+00 -1.42004162427E+00 -1.43427164602E+00 -1.44862583005E+00 -1.46313781663E+00 -1.47794965768E+00 -1.49271785961E+00 -1.50779818504E+00 -1.52286989167E+00 -1.53824899708E+00 -1.55374268099E+00 -1.56922182693E+00 -1.58510177289E+00 -1.60090610336E+00 -1.61706308927E+00 -1.63325623945E+00 -1.64969297997E+00 -1.66634065580E+00 -1.68301601831E+00 -1.69995655996E+00 -1.71700470943E+00 -1.73427055444E+00 -1.75168215049E+00 -1.76925855533E+00 -1.78710069653E+00 -1.80505949800E+00 -1.82325834515E+00 -1.84141665498E+00 -1.86004847861E+00 -1.87869816710E+00 -1.89755784905E+00 -1.91665259003E+00 -1.93593688827E+00 -1.95543865864E+00 -1.97503889827E+00 -1.99480624125E+00 -2.01492512913E+00 -2.03518980336E+00 -2.05556882040E+00 -2.07621215467E+00 -2.09712632797E+00 -2.11821119391E+00 -2.13947228112E+00 -2.16096937489E+00 -2.18271399688E+00 -2.20456735667E+00 -2.22680443249E+00 -2.24916870863E+00 -2.27169301205E+00 -2.29459467503E+00 -2.31764762604E+00 -2.34088115835E+00 -2.36442546596E+00 -2.38815320205E+00 -2.41219704441E+00 -2.43642594947E+00 -2.46087796134E+00 -2.48565130081E+00 -2.51054299526E+00 -2.53580032509E+00 -2.56126908555E+00 -2.58695098305E+00 -2.61298761746E+00 -2.63925218443E+00 -2.66572809977E+00 -2.69253642361E+00 -2.71959274792E+00 -2.74688178497E+00 -2.77451465689E+00 -2.80236087776E+00 -2.83053995517E+00 -2.85904924780E+00 -2.88767802102E+00 -2.91669170804E+00 -2.94597834137E+00 -2.97557088440E+00 -3.00550013336E+00 -3.03563839975E+00 -3.06618366490E+00 -3.09693706536E+00 -3.12805628478E+00 -3.15952686985E+00 -3.19122908175E+00 -3.22329264704E+00 -3.25565342770E+00 -3.28835125946E+00 -3.32140303845E+00 -3.35477144763E+00 -3.38843425365E+00 -3.42250586385E+00 -3.45681257313E+00 -3.49162759907E+00 -3.52663531263E+00 -3.56207896531E+00 -3.59783399633E+00 -3.63397687731E+00 -3.67048162339E+00 -3.70727504618E+00 -3.74459318210E+00 -3.78216499277E+00 -3.82014441587E+00 -3.85849372516E+00 -3.89724824430E+00 -3.93637796414E+00 -3.97590524336E+00 -4.01585733278E+00 -4.05615033002E+00 -4.09689264941E+00 -4.13803209223E+00 -4.17954242884E+00 -4.22154788591E+00 -4.26393499837E+00 -4.30675643100E+00 -4.34998889618E+00 -4.39364151643E+00 -4.43777084506E+00 -4.48231518826E+00 -4.52730719429E+00 -4.57275320894E+00 -4.61867848976E+00 -4.66506213026E+00 -4.71182313808E+00 -4.75916702742E+00 -4.80692126251E+00 -4.85519406156E+00 -4.90389580140E+00 -4.95312077964E+00 -5.00287048856E+00 -5.05305552152E+00 -5.10376582290E+00 -5.15496750356E+00 -5.20674283329E+00 -5.25897707655E+00 -5.31174067180E+00 -5.36507016698E+00 -5.41889200384E+00 -5.47324659019E+00 -5.52820670097E+00 -5.58362750962E+00 -5.63965862575E+00 -5.69624671592E+00 -5.75341359067E+00 -5.81111086821E+00 -5.86938861076E+00 -5.92827102882E+00 -5.98776313150E+00 -6.04779649908E+00 -6.10846915958E+00 -6.16974482793E+00 -6.23160829575E+00 -6.29411512271E+00 -6.35722256432E+00 -6.42097310455E+00 -6.48535795174E+00 -6.55038573587E+00 -6.61606738691E+00 -6.68239674463E+00 -6.74939466988E+00 -6.81705592530E+00 -6.88540816905E+00 -6.95440864404E+00 -7.02412168104E+00 -7.09453553809E+00 -7.16563577249E+00 -7.23744824321E+00 -7.30997513175E+00 -7.38322687777E+00 -7.45719463678E+00 -7.53194606523E+00 -7.60737094400E+00 -7.68359077110E+00 -7.76057989472E+00 -7.83830933046E+00 -7.91681245952E+00 -7.99611529272E+00 -8.07618744642E+00 -8.15706390210E+00 -8.23875493425E+00 -8.32124330265E+00 -8.40456505787E+00 -8.48869181210E+00 -8.57367557671E+00 -8.65949049299E+00 -8.74615163665E+00 -8.83368640794E+00 -8.92210084517E+00 -9.01137428585E+00 -9.10152552272E+00 -9.19259262919E+00 -9.28455384502E+00 -9.37741694903E+00 -9.47119887928E+00 -9.56592302606E+00 -9.66157180825E+00 -9.75819112946E+00 -9.85574018647E+00 -9.95427071689E+00 -1.00537686071E+01 -1.01542573085E+01 -1.02557266828E+01 -1.03581952815E+01 -1.04616996908E+01 -1.05661972920E+01 -1.06717406346E+01 -1.07783159391E+01 -1.08859472314E+01 -1.09946501655E+01 -1.11044078492E+01 -1.12152487147E+01 -1.13271887403E+01 -1.14402271824E+01 -1.15543621548E+01 -1.16696442808E+01 -1.17860443955E+01 -1.19035877132E+01 -1.20222907474E+01 -1.21421535423E+01 -1.22631929733E+01 -1.23854248799E+01 -1.25088531151E+01 -1.26334754802E+01 -1.27593283572E+01 -1.28864135985E+01 -1.30147247439E+01 -1.31443210913E+01 -1.32751499408E+01 -1.34072844231E+01 -1.35406841353E+01 -1.36753923569E+01 -1.38114143213E+01 -1.39487552774E+01 -1.40874468278E+01 -1.42274637074E+01 -1.43688541248E+01 -1.45116155450E+01 -1.46557650446E+01 -1.48013086498E+01 -1.49482548717E+01 -1.50966281610E+01 -1.52464360320E+01 -1.53977009472E+01 -1.55504052464E+01 -1.57046114782E+01 -1.58602767607E+01 -1.60174530763E+01 -1.61761433708E+01 -1.63363549076E+01 -1.64981037012E+01 -1.66614097922E+01 -1.68262814367E+01 -1.69927215392E+01 -1.71607661918E+01 -1.73304052707E+01 -1.75016786803E+01 -1.76745648123E+01 -1.78491211604E+01 -1.80253123331E+01 -1.82031965461E+01 -1.83827547384E+01 -1.85640311799E+01 -1.87470071018E+01 -1.89317301970E+01 -1.91181896960E+01 -1.93064057314E+01 -1.94963986401E+01 -1.96881730665E+01 -1.98817483768E+01 -2.00771476679E+01 -2.02743694468E+01 -2.04734379718E+01 -2.06743663201E+01 -2.08771662018E+01 -2.10818458461E+01 -2.12884380962E+01 -2.14969442367E+01 -2.17073805358E+01 -2.19197570063E+01 -2.21340964871E+01 -2.23504096780E+01 -2.25687136940E+01 -2.27890139533E+01 -2.30113397224E+01 -2.32356876966E+01 -2.34620848379E+01 -2.36905444119E+01 -2.39210762020E+01 -2.41536995652E+01 -2.43884213903E+01 -2.46252587373E+01 -2.48642274823E+01 -2.51053445179E+01 -2.53486055958E+01 -2.55940561729E+01 -2.58416838034E+01 -2.60915166340E+01 -2.63435469532E+01 -2.65978184065E+01 -2.68543214390E+01 -2.71130737664E+01 -2.73740963709E+01 -2.76373928041E+01 -2.79029801971E+01 -2.81708630962E+01 -2.84410773395E+01 -2.87136030147E+01 -2.89884729370E+01 -2.92656893296E+01 -2.95452651646E+01 -2.98272201833E+01 -3.01115503085E+01 -3.03982723349E+01 -3.06874006769E+01 -3.09789448560E+01 -3.12729115011E+01 -3.15693030933E+01 -3.18681383679E+01 -3.21694237630E+01 -3.24731677873E+01 -3.27793722878E+01 -3.30880517267E+01 -3.33992132382E+01 -3.37128564250E+01 -3.40289934067E+01 -3.43476247098E+01 -3.46687568645E+01 -3.49923941111E+01 -3.53185463083E+01 -3.56472097123E+01 -3.59783891110E+01 -3.63120810172E+01 -3.66482985196E+01 -3.69870313311E+01 -3.73282846388E+01 -3.76720593294E+01 -3.80183509959E+01 -3.83671549737E+01 -3.87184706220E+01 -3.90722934399E+01 -3.94286200701E+01 -3.97874473053E+01 -4.01487607518E+01 -4.05125557627E+01 -4.08788240266E+01 -4.12475617506E+01 -4.16187467269E+01 -4.19923776141E+01 -4.23684329972E+01 -4.27469027448E+01 -4.31277700205E+01 -4.35110210272E+01 -4.38966343992E+01 -4.42845876266E+01 -4.46748691306E+01 -4.50674428609E+01 -4.54623002512E+01 -4.58594041917E+01 -4.62587323037E+01 -4.66602551632E+01 -4.70639418203E+01 -4.74697611293E+01 -4.78776775345E+01 -4.82876547083E+01 -4.86996586420E+01 -4.91136470901E+01 -4.95295757518E+01 -4.99474080446E+01 -5.03670843579E+01 -5.07885671563E+01 -5.12118076711E+01 -5.16367459372E+01 -5.20633260297E+01 -5.24914963499E+01 -5.29211903912E+01 -5.33523492419E+01 -5.37849036856E+01 -5.42187851643E+01 -5.46539253899E+01 -5.50902466629E+01 -5.55276692437E+01 -5.59661211266E+01 -5.64055075970E+01 -5.68457485801E+01 -5.72867481227E+01 -5.77284166409E+01 -5.81706567960E+01 -5.86133624528E+01 -5.90564333105E+01 -5.94997569601E+01 -5.99432225745E+01 -6.03867157945E+01 -6.08301104831E+01 -6.12732836148E+01 -6.17161081310E+01 -6.21584469836E+01 -6.26001612539E+01 -6.30411103909E+01 -6.34811473669E+01 -6.39201164388E+01 -6.43578606539E+01 -6.47942216695E+01 -6.52290270714E+01 -6.56621039649E+01 -6.60932769769E+01 -6.65223606559E+01 -6.69491644542E+01 -6.73734972622E+01 -6.77951536281E+01 -6.82139294188E+01 -6.86296111321E+01 -6.90419801614E+01 -6.94508117324E+01 -6.98558744889E+01 -7.02569300591E+01 -7.06537335889E+01 -7.10460374990E+01 -7.14335796492E+01 -7.18160992322E+01 -7.21933229582E+01 -7.25649718646E+01 -7.29307651414E+01 -7.32904068977E+01 -7.36435969150E+01 -7.39900305063E+01 -7.43293943923E+01 -7.46613631641E+01 -7.49856118733E+01 -7.53018032363E+01 -7.56095901868E+01 -7.59086278119E+01 -7.61985523417E+01 -7.64789980922E+01 -7.67495931176E+01 -7.70099539962E+01 -7.72596934889E+01 -7.74984132972E+01 -7.77257135944E+01 -7.79411796521E+01 -7.81443962393E+01 -7.83349357924E+01 -7.85123664865E+01 -7.86762499307E+01 -7.88261419303E+01 -7.89615882529E+01 -7.90821304369E+01 -7.91873050179E+01 -7.92766410119E+01 -7.93496622791E+01 -7.94058888446E+01 -7.94448341147E+01 -7.94660070211E+01 -7.94689142464E+01 -7.94530565638E+01 -7.94179339624E+01 -7.93630400292E+01 -7.92878719865E+01 -7.91919192376E+01 -7.90746737925E+01 -7.89356268201E+01 -7.87742696790E+01 -7.85900967424E+01 -7.83826013725E+01 -7.81512828397E+01 -7.78956428294E+01 -7.76151873404E+01 -7.73094295040E+01 -7.69778917990E+01 -7.66200970362E+01 -7.62355869233E+01 -7.58239108753E+01 -7.53846277096E+01 -7.49173118958E+01 -7.44215532299E+01 -7.38969584731E+01 -7.33431537581E+01 -7.27597835459E+01 -7.21465161297E+01 -7.15030425681E+01 -7.08290822719E+01 -7.01243782861E+01 -6.93887102157E+01 -6.86218862522E+01 -6.78237500083E+01 -6.69941855383E+01 -6.61331134137E+01 -6.52404985855E+01 -6.43163546008E+01 -6.33607351366E+01 -6.23737567409E+01 -6.13555800559E+01 -6.03064295452E+01 -5.92265859054E+01 -5.81163961551E+01 -5.69762762963E+01 -5.58067079952E+01 -5.46082497128E+01 -5.33815364034E+01 -5.21272867775E+01 -5.08462989517E+01 -4.95394627026E+01 -4.82077601142E+01 -4.68522638033E+01 -4.54741498308E+01 -4.40746936635E+01 -4.26552774035E+01 -4.12173930989E+01 -3.97626405005E+01 -3.82927408886E+01 -3.68095296792E+01 -3.53149638137E+01 -3.38111242764E+01 -3.23002188191E+01 -3.07845785304E+01 -2.92666715432E+01 -2.77490893848E+01 -2.62345595218E+01 -2.47259378530E+01 -2.32262141218E+01 -2.17385094465E+01 -2.02660726667E+01 -1.88122798564E+01 -1.73806327615E+01 -1.59747520081E+01 -1.45983743863E+01 -1.32553460689E+01 -1.19496185870E+01 -1.06852337659E+01 -9.46632303176E+00 -8.29708978291E+00 -7.18179979954E+00 -6.12477018995E+00 -5.13034687619E+00 -4.20289459386E+00 -3.34677116682E+00 -2.56631355882E+00 -1.86580624919E+00 -1.24946256933E+00 -7.21391752087E-01 -2.85574130357E-01 5.41778643984E-02 2.94250489397E-01 4.31270575627E-01 4.62140224596E-01 3.84087511551E-01 1.94708868868E-01 -1.07982525822E-01 -5.25504077620E-01 -1.05884682636E+00 -1.70842189064E+00 -2.47400001105E+00 -3.35464791214E+00 -4.34866586133E+00 -5.45352281628E+00 -6.66578678682E+00 -7.98105954408E+00 -9.39390503626E+00 -1.08977850497E+01 -1.24849861041E+01 -1.41465601548E+01 -1.58722574762E+01 -1.76504657031E+01 -1.94681621322E+01 -2.13108595074E+01 -2.31625694603E+01 -2.50057732263E+01 -2.68214020484E+01 -2.85888351185E+01 -3.02859120547E+01 -3.18889649470E+01 -3.33728747745E+01 -3.47111491975E+01 -3.58760325202E+01 -3.68386472424E+01 -3.75691719932E+01 -3.80370616059E+01 -3.82113075894E+01 -3.80607532867E+01 -3.75544593790E+01 -3.66621267622E+01 -3.53545847772E+01 -3.36043413382E+01 -3.13862057394E+01 -2.86779798117E+01 -2.54612245414E+01 -2.17221001514E+01 -1.74522749308E+01 -1.26499038334E+01 -7.32066436883E+00 -1.47884568704E+00 4.85153643202E+00 1.16356057395E+01 1.88265134478E+01 2.63643811690E+01 3.41753412572E+01 4.21707439172E+01 5.02465999201E+01 5.82833526074E+01 6.61460941459E+01 7.36853645096E+01 8.07387026249E+01 8.71331488772E+01 9.26889504215E+01 9.72247560973E+01 1.00564648326E+02 1.02547435317E+02 1.03038684282E+02 1.01946083195E+02 9.92388158942E+01 9.49717537112E+01 8.92509547556E+01 8.20164386538E+01 7.31520969594E+01 6.25375326606E+01 5.00445038125E+01 3.55720292209E+01 1.87047409088E+01 2.04549424759E+00 -2.03560521026E-01 2.02576526909E-02 -2.01595911688E-03 2.00614418981E-04 -1.99580543037E-05 2.00677122831E-06 -2.43469654134E-07 4.22995606945E-08 -4.30536055020E-08 1.20271318011E-08 2 0 Beta L 629 1.77912265614E+00 1.79700062244E+00 1.81505818873E+00 1.83329715770E+00 1.85186688240E+00 1.87042540154E+00 1.88914580006E+00 1.90807187767E+00 1.92738555478E+00 1.94664643597E+00 1.96631090366E+00 1.98596768205E+00 2.00602170502E+00 2.02622618261E+00 2.04641543659E+00 2.06712194060E+00 2.08773500609E+00 2.10880372817E+00 2.12992235425E+00 2.15135692768E+00 2.17306551672E+00 2.19481327758E+00 2.21690471390E+00 2.23913799566E+00 2.26165392191E+00 2.28436067710E+00 2.30728254127E+00 2.33054896606E+00 2.35396895490E+00 2.37770063130E+00 2.40138438691E+00 2.42567917923E+00 2.45000110354E+00 2.47459628344E+00 2.49949705230E+00 2.52464503352E+00 2.55007614051E+00 2.57563774452E+00 2.60141793067E+00 2.62765324412E+00 2.65407989662E+00 2.68065761599E+00 2.70757874145E+00 2.73485162342E+00 2.76234804069E+00 2.79007495813E+00 2.81810927515E+00 2.84646555045E+00 2.87496620669E+00 2.90396353404E+00 2.93312884051E+00 2.96250438013E+00 2.99236853065E+00 3.02243188873E+00 3.05273174562E+00 3.08343518534E+00 3.11437903802E+00 3.14573347498E+00 3.17733032025E+00 3.20921871169E+00 3.24152436651E+00 3.27398735513E+00 3.30692454232E+00 3.34013838014E+00 3.37363113880E+00 3.40758441179E+00 3.44183556896E+00 3.47636358150E+00 3.51132353568E+00 3.54660751313E+00 3.58219567602E+00 3.61823079106E+00 3.65454546979E+00 3.69129312299E+00 3.72847027377E+00 3.76580699989E+00 3.80364348195E+00 3.84183635101E+00 3.88042788882E+00 3.91945762393E+00 3.95876199871E+00 3.99859476653E+00 4.03870120143E+00 4.07928343034E+00 4.12032293430E+00 4.16166642660E+00 4.20348021039E+00 4.24568209139E+00 4.28832327719E+00 4.33142541573E+00 4.37494090709E+00 4.41884109006E+00 4.46327290419E+00 4.50801365109E+00 4.55341369938E+00 4.59906837835E+00 4.64528980728E+00 4.69191821463E+00 4.73905182575E+00 4.78665727404E+00 4.83464096369E+00 4.88330545520E+00 4.93230349155E+00 4.98183230362E+00 5.03184382471E+00 5.08238325857E+00 5.13341228730E+00 5.18495972161E+00 5.23706045829E+00 5.28960708786E+00 5.34273870619E+00 5.39638845002E+00 5.45052278202E+00 5.50530107050E+00 5.56057789940E+00 5.61642098716E+00 5.67280041409E+00 5.72972811698E+00 5.78727658637E+00 5.84536691937E+00 5.90404097514E+00 5.96330705147E+00 6.02319759505E+00 6.08368594623E+00 6.14466831277E+00 6.20640831115E+00 6.26868484077E+00 6.33163673076E+00 6.39514921755E+00 6.45934326425E+00 6.52422089904E+00 6.58966760887E+00 6.65579887377E+00 6.72257124504E+00 6.79009038870E+00 6.85820928019E+00 6.92701839562E+00 6.99656463575E+00 7.06675384002E+00 7.13763792194E+00 7.20931036035E+00 7.28158548462E+00 7.35465533426E+00 7.42845155761E+00 7.50300233109E+00 7.57824566207E+00 7.65424595245E+00 7.73103426162E+00 7.80861724794E+00 7.88690721901E+00 7.96603005275E+00 8.04593933027E+00 8.12661570726E+00 8.20813050428E+00 8.29042909657E+00 8.37356608820E+00 8.45753030375E+00 8.54233300691E+00 8.62798827887E+00 8.71448841064E+00 8.80186026737E+00 8.89009732864E+00 8.97923510986E+00 9.06921901745E+00 9.16013162781E+00 9.25195807205E+00 9.34467995207E+00 9.43833058742E+00 9.53291293310E+00 9.62844053086E+00 9.72490216756E+00 9.82238478384E+00 9.92074719129E+00 1.00201453694E+01 1.01205465198E+01 1.02219136968E+01 1.03242898555E+01 1.04277085140E+01 1.05321308721E+01 1.06376019476E+01 1.07441351012E+01 1.08517083747E+01 1.09603682081E+01 1.10700783219E+01 1.11809056193E+01 1.12928171095E+01 1.14058323170E+01 1.15199865276E+01 1.16352876810E+01 1.17517094620E+01 1.18692761833E+01 1.19880367996E+01 1.21079636433E+01 1.22290668295E+01 1.23513683509E+01 1.24748982995E+01 1.25996343914E+01 1.27256356427E+01 1.28528499831E+01 1.29813438911E+01 1.31110995216E+01 1.32421471227E+01 1.33744739206E+01 1.35081038987E+01 1.36430841618E+01 1.37793603061E+01 1.39169999081E+01 1.40559855139E+01 1.41963481653E+01 1.43381081032E+01 1.44812439552E+01 1.46257923445E+01 1.47717740258E+01 1.49191882182E+01 1.50680328018E+01 1.52183728450E+01 1.53701712367E+01 1.55234605162E+01 1.56782620927E+01 1.58345762569E+01 1.59924249086E+01 1.61518285583E+01 1.63127924353E+01 1.64753139202E+01 1.66394399529E+01 1.68051731125E+01 1.69725054102E+01 1.71415130837E+01 1.73121288561E+01 1.74844467265E+01 1.76584151630E+01 1.78340898939E+01 1.80114779264E+01 1.81905862197E+01 1.83714555792E+01 1.85540538852E+01 1.87384431905E+01 1.89246205462E+01 1.91126080927E+01 1.93024138571E+01 1.94940490061E+01 1.96875451936E+01 1.98829123026E+01 2.00801794399E+01 2.02793242451E+01 2.04804271840E+01 2.06834335776E+01 2.08884103614E+01 2.10953615960E+01 2.13042969117E+01 2.15152370962E+01 2.17282081751E+01 2.19432210104E+01 2.21602796356E+01 2.23794306215E+01 2.26006613002E+01 2.28240231231E+01 2.30494887041E+01 2.32771320613E+01 2.35069081265E+01 2.37388918450E+01 2.39730590969E+01 2.42094669614E+01 2.44480916614E+01 2.46889946933E+01 2.49321625345E+01 2.51776213521E+01 2.54253974986E+01 2.56754972817E+01 2.59279458356E+01 2.61827730997E+01 2.64399774813E+01 2.66995904110E+01 2.69616289705E+01 2.72261085092E+01 2.74930398910E+01 2.77624655722E+01 2.80343875048E+01 2.83088268885E+01 2.85857968790E+01 2.88653271005E+01 2.91474315871E+01 2.94321326106E+01 2.97194374580E+01 3.00093839672E+01 3.03019682411E+01 3.05972251663E+01 3.08951720881E+01 3.11958218646E+01 3.14991996554E+01 3.18053146096E+01 3.21141889265E+01 3.24258432853E+01 3.27402996705E+01 3.30575529552E+01 3.33776617374E+01 3.37006103828E+01 3.40264352946E+01 3.43551269070E+01 3.46867414807E+01 3.50212670888E+01 3.53587267456E+01 3.56991476579E+01 3.60425347017E+01 3.63889101148E+01 3.67382800440E+01 3.70906907220E+01 3.74461169207E+01 3.78046009885E+01 3.81661460678E+01 3.85307690728E+01 3.88984955774E+01 3.92693206422E+01 3.96432660495E+01 4.00203505547E+01 4.04005866091E+01 4.07839829720E+01 4.11705430637E+01 4.15602911424E+01 4.19532356984E+01 4.23493878600E+01 4.27487502178E+01 4.31513415205E+01 4.35571711187E+01 4.39662387032E+01 4.43785599889E+01 4.47941358360E+01 4.52129747800E+01 4.56350824241E+01 4.60604715436E+01 4.64891374931E+01 4.69210865264E+01 4.73563142950E+01 4.77948376826E+01 4.82366435934E+01 4.86817387624E+01 4.91301243851E+01 4.95817948748E+01 5.00367442863E+01 5.04949718260E+01 5.09564717335E+01 5.14212396998E+01 5.18892715918E+01 5.23605489184E+01 5.28350656683E+01 5.33128111156E+01 5.37937803003E+01 5.42779446531E+01 5.47653023106E+01 5.52558256843E+01 5.57495015973E+01 5.62463082908E+01 5.67462278480E+01 5.72492326521E+01 5.77552935760E+01 5.82643954954E+01 5.87764918844E+01 5.92915714202E+01 5.98095861672E+01 6.03305070462E+01 6.08542959208E+01 6.13809126591E+01 6.19103168658E+01 6.24424624418E+01 6.29773022820E+01 6.35147922173E+01 6.40548774846E+01 6.45975006504E+01 6.51426141468E+01 6.56901408452E+01 6.62400318819E+01 6.67922239458E+01 6.73466393549E+01 6.79032055430E+01 6.84618554656E+01 6.90225029207E+01 6.95850713992E+01 7.01494711415E+01 7.07156131860E+01 7.12834088716E+01 7.18527574294E+01 7.24235554247E+01 7.29957092884E+01 7.35690962963E+01 7.41436124389E+01 7.47191332964E+01 7.52955425708E+01 7.58727139632E+01 7.64505098480E+01 7.70288000218E+01 7.76074387102E+01 7.81862821014E+01 7.87651818056E+01 7.93439742757E+01 7.99224998882E+01 8.05005938011E+01 8.10780782952E+01 8.16547732035E+01 8.22304961940E+01 8.28050565783E+01 8.33782524276E+01 8.39498802026E+01 8.45197345180E+01 8.50875918856E+01 8.56532281335E+01 8.62164158560E+01 8.67769146528E+01 8.73344775361E+01 8.78888567251E+01 8.84397859935E+01 8.89870007388E+01 8.95302242860E+01 9.00691733482E+01 9.06035566766E+01 9.11330745154E+01 9.16574180568E+01 9.21762701222E+01 9.26893099822E+01 9.31961981770E+01 9.36965969096E+01 9.41901523128E+01 9.46765032078E+01 9.51552859854E+01 9.56261176641E+01 9.60886096615E+01 9.65423676277E+01 9.69869861560E+01 9.74220442567E+01 9.78471214883E+01 9.82617815796E+01 9.86655756815E+01 9.90580576927E+01 9.94387573172E+01 9.98072017968E+01 1.00162910340E+02 1.00505387447E+02 1.00834132726E+02 1.01148631626E+02 1.01448367657E+02 1.01732805251E+02 1.02001408239E+02 1.02253624679E+02 1.02488897226E+02 1.02706660180E+02 1.02906340475E+02 1.03087352260E+02 1.03249104358E+02 1.03390999288E+02 1.03512430046E+02 1.03612783155E+02 1.03691440362E+02 1.03747775095E+02 1.03781155217E+02 1.03790945899E+02 1.03776504945E+02 1.03737189378E+02 1.03672348251E+02 1.03581335541E+02 1.03463495478E+02 1.03318175932E+02 1.03144724015E+02 1.02942487420E+02 1.02710818066E+02 1.02449066963E+02 1.02156593100E+02 1.01832758994E+02 1.01476933150E+02 1.01088493693E+02 1.00666831243E+02 1.00211337380E+02 9.97214284674E+01 9.91965313388E+01 9.86360854990E+01 9.80395511659E+01 9.74064088771E+01 9.67361616251E+01 9.60283379709E+01 9.52824907324E+01 9.44982040782E+01 9.36750921822E+01 9.28128064208E+01 9.19110293499E+01 9.09694913124E+01 8.99879602356E+01 8.89662504282E+01 8.79042290439E+01 8.68018110715E+01 8.56589694486E+01 8.44757404818E+01 8.32522130246E+01 8.19885576447E+01 8.06850025774E+01 7.93418590280E+01 7.79595114617E+01 7.65384305423E+01 7.50791765602E+01 7.35823951753E+01 7.20488316914E+01 7.04793306630E+01 6.88748451987E+01 6.72364313753E+01 6.55652639197E+01 6.38626370231E+01 6.21299620320E+01 6.03687839596E+01 5.85807762662E+01 5.67677500741E+01 5.49316583501E+01 5.30745929566E+01 5.11988023008E+01 4.93066817615E+01 4.74007830639E+01 4.54838173950E+01 4.35586587664E+01 4.16283394857E+01 3.96960675742E+01 3.77652091038E+01 3.58393041039E+01 3.39220567369E+01 3.20173420345E+01 3.01292024982E+01 2.82618431814E+01 2.64196307952E+01 2.46070914381E+01 2.28289015871E+01 2.10898843033E+01 1.93950002088E+01 1.77493419725E+01 1.61581146326E+01 1.46266343158E+01 1.31603052330E+01 1.17646069600E+01 1.04450798199E+01 9.20729556625E+00 8.05684408173E+00 6.99929990863E+00 6.04020386270E+00 5.18502197209E+00 4.43912102237E+00 3.80772577631E+00 3.29588663471E+00 2.90842909114E+00 2.64991371180E+00 2.52458189601E+00 2.53631085440E+00 2.68854808194E+00 2.98425650747E+00 3.42585197103E+00 4.01513523071E+00 4.75321852541E+00 5.64045651959E+00 6.67636845457E+00 7.85955626872E+00 9.18762432120E+00 1.06570960922E+01 1.22633248335E+01 1.40004098803E+01 1.58611050009E+01 1.78367361499E+01 1.99171081077E+01 2.20904289637E+01 2.43432247243E+01 2.66602619877E+01 2.90244877932E+01 3.14169613170E+01 3.38168084084E+01 3.62011856821E+01 3.85452572657E+01 4.08221942917E+01 4.30031932845E+01 4.50575199277E+01 4.69525843636E+01 4.86540442055E+01 5.01259491115E+01 5.13309261792E+01 5.22304123132E+01 5.27849409521E+01 5.29544809150E+01 5.26988456828E+01 5.19781675350E+01 5.07534455380E+01 4.89871775842E+01 4.66440720218E+01 4.36918526500E+01 4.01021514731E+01 3.58514982608E+01 3.09224042657E+01 2.53045339465E+01 1.89959658839E+01 1.20045267412E+01 4.34919283975E+00 -3.93847584418E+00 -1.28128785448E+01 -2.22129457954E+01 -3.20607836715E+01 -4.22604449221E+01 -5.26969163386E+01 -6.32354111117E+01 -7.37210868398E+01 -8.39793372130E+01 -9.38168356282E+01 -1.03023548781E+02 -1.11375976537E+02 -1.18641941490E+02 -1.24587297076E+02 -1.28985000903E+02 -1.31627097515E+02 -1.32340228523E+02 -1.31005425190E+02 -1.27583063497E+02 -1.22144013699E+02 -1.14825088111E+02 -1.05548936568E+02 -9.41658678805E+01 -8.05207145865E+01 -6.44482553131E+01 -4.58184506916E+01 -2.40962584774E+01 -2.63547974748E+00 2.62273839374E-01 -2.61006028683E-02 2.59742576635E-03 -2.58477999899E-04 2.57146011339E-05 -2.58544973719E-06 3.13405733994E-07 -5.43670169166E-08 5.52177192593E-08 -1.54172530108E-08 3 Number of nonzero Dij 1 1 -4.01129905560E-02 1 2 -2.89923362526E-02 2 2 -2.04858274171E-02 0 nqf. If not zero, Qij's inside rinner are computed using qfcoef's 1 1 0 i j (l(j)) 1.71704519446E-02 Q_int 3.28262092815E-06 3.34893214274E-06 3.41658284592E-06 3.48560009362E-06 3.55601148817E-06 3.62784518938E-06 3.70112992575E-06 3.77589500598E-06 3.85217033067E-06 3.92998640428E-06 4.00937434732E-06 4.09036590877E-06 4.17299347881E-06 4.25729010170E-06 4.34328948907E-06 4.43102603330E-06 4.52053482133E-06 4.61185164867E-06 4.70501303367E-06 4.80005623215E-06 4.89701925228E-06 4.99594086975E-06 5.09686064327E-06 5.19981893039E-06 5.30485690362E-06 5.41201656685E-06 5.52134077218E-06 5.63287323702E-06 5.74665856153E-06 5.86274224647E-06 5.98117071138E-06 6.10199131310E-06 6.22525236469E-06 6.35100315476E-06 6.47929396712E-06 6.61017610088E-06 6.74370189094E-06 6.87992472891E-06 7.01889908441E-06 7.16068052681E-06 7.30532574750E-06 7.45289258241E-06 7.60344003523E-06 7.75702830088E-06 7.91371878960E-06 8.07357415145E-06 8.23665830131E-06 8.40303644446E-06 8.57277510254E-06 8.74594214015E-06 8.92260679195E-06 9.10283969026E-06 9.28671289330E-06 9.47429991393E-06 9.66567574901E-06 9.86091690931E-06 1.00601014501E-05 1.02633090022E-05 1.04706208038E-05 1.06821197331E-05 1.08978903411E-05 1.11180188852E-05 1.13425933641E-05 1.15717035527E-05 1.18054410378E-05 1.20438992545E-05 1.22871735240E-05 1.25353610913E-05 1.27885611637E-05 1.30468749511E-05 1.33104057056E-05 1.35792587633E-05 1.38535415857E-05 1.41333638032E-05 1.44188372584E-05 1.47100760508E-05 1.50071965822E-05 1.53103176034E-05 1.56195602610E-05 1.59350481463E-05 1.62569073443E-05 1.65852664838E-05 1.69202567888E-05 1.72620121309E-05 1.76106690825E-05 1.79663669713E-05 1.83292479355E-05 1.86994569812E-05 1.90771420391E-05 1.94624540243E-05 1.98555468961E-05 2.02565777190E-05 2.06657067260E-05 2.10830973814E-05 2.15089164469E-05 2.19433340472E-05 2.23865237380E-05 2.28386625754E-05 2.32999311857E-05 2.37705138379E-05 2.42505985166E-05 2.47403769971E-05 2.52400449213E-05 2.57498018761E-05 2.62698514720E-05 2.68004014248E-05 2.73416636379E-05 2.78938542864E-05 2.84571939033E-05 2.90319074668E-05 2.96182244902E-05 3.02163791127E-05 3.08266101926E-05 3.14491614022E-05 3.20842813244E-05 3.27322235518E-05 3.33932467868E-05 3.40676149451E-05 3.47555972598E-05 3.54574683885E-05 3.61735085224E-05 3.69040034972E-05 3.76492449068E-05 3.84095302189E-05 3.91851628928E-05 3.99764524997E-05 4.07837148457E-05 4.16072720969E-05 4.24474529068E-05 4.33045925468E-05 4.41790330390E-05 4.50711232914E-05 4.59812192365E-05 4.69096839718E-05 4.78568879036E-05 4.88232088939E-05 4.98090324096E-05 5.08147516748E-05 5.18407678270E-05 5.28874900748E-05 5.39553358604E-05 5.50447310241E-05 5.61561099728E-05 5.72899158515E-05 5.84466007182E-05 5.96266257226E-05 6.08304612879E-05 6.20585872964E-05 6.33114932790E-05 6.45896786080E-05 6.58936526941E-05 6.72239351873E-05 6.85810561812E-05 6.99655564224E-05 7.13779875229E-05 7.28189121774E-05 7.42889043850E-05 7.57885496743E-05 7.73184453345E-05 7.88792006495E-05 8.04714371377E-05 8.20957887960E-05 8.37529023486E-05 8.54434375012E-05 8.71680671997E-05 8.89274778938E-05 9.07223698066E-05 9.25534572088E-05 9.44214686985E-05 9.63271474862E-05 9.82712516865E-05 1.00254554614E-04 1.02277845084E-04 1.04341927727E-04 1.06447623294E-04 1.08595768983E-04 1.10787218767E-04 1.13022843721E-04 1.15303532367E-04 1.17630191017E-04 1.20003744128E-04 1.22425134663E-04 1.24895324452E-04 1.27415294574E-04 1.29986045730E-04 1.32608598640E-04 1.35283994433E-04 1.38013295051E-04 1.40797583666E-04 1.43637965092E-04 1.46535566220E-04 1.49491536449E-04 1.52507048132E-04 1.55583297029E-04 1.58721502768E-04 1.61922909316E-04 1.65188785459E-04 1.68520425289E-04 1.71919148704E-04 1.75386301915E-04 1.78923257961E-04 1.82531417239E-04 1.86212208042E-04 1.89967087101E-04 1.93797540150E-04 1.97705082489E-04 2.01691259564E-04 2.05757647561E-04 2.09905854002E-04 2.14137518360E-04 2.18454312684E-04 2.22857942235E-04 2.27350146130E-04 2.31932698008E-04 2.36607406698E-04 2.41376116906E-04 2.46240709909E-04 2.51203104274E-04 2.56265256573E-04 2.61429162124E-04 2.66696855744E-04 2.72070412510E-04 2.77551948543E-04 2.83143621794E-04 2.88847632862E-04 2.94666225806E-04 3.00601688991E-04 3.06656355939E-04 3.12832606193E-04 3.19132866210E-04 3.25559610254E-04 3.32115361316E-04 3.38802692047E-04 3.45624225709E-04 3.52582637140E-04 3.59680653740E-04 3.66921056473E-04 3.74306680886E-04 3.81840418146E-04 3.89525216100E-04 3.97364080347E-04 4.05360075330E-04 4.13516325453E-04 4.21836016210E-04 4.30322395341E-04 4.38978773997E-04 4.47808527941E-04 4.56815098752E-04 4.66001995064E-04 4.75372793820E-04 4.84931141546E-04 4.94680755647E-04 5.04625425731E-04 5.14769014944E-04 5.25115461340E-04 5.35668779262E-04 5.46433060753E-04 5.57412476991E-04 5.68611279738E-04 5.80033802826E-04 5.91684463657E-04 6.03567764731E-04 6.15688295196E-04 6.28050732428E-04 6.40659843628E-04 6.53520487451E-04 6.66637615657E-04 6.80016274786E-04 6.93661607864E-04 7.07578856128E-04 7.21773360784E-04 7.36250564784E-04 7.51016014637E-04 7.66075362241E-04 7.81434366742E-04 7.97098896424E-04 8.13074930622E-04 8.29368561663E-04 8.45985996834E-04 8.62933560378E-04 8.80217695517E-04 8.97844966504E-04 9.15822060694E-04 9.34155790657E-04 9.52853096303E-04 9.71921047043E-04 9.91366843980E-04 1.01119782211E-03 1.03142145258E-03 1.05204534494E-03 1.07307724944E-03 1.09452505935E-03 1.11639681331E-03 1.13870069770E-03 1.16144504902E-03 1.18463835635E-03 1.20828926375E-03 1.23240657276E-03 1.25699924492E-03 1.28207640420E-03 1.30764733965E-03 1.33372150788E-03 1.36030853567E-03 1.38741822260E-03 1.41506054363E-03 1.44324565177E-03 1.47198388074E-03 1.50128574763E-03 1.53116195561E-03 1.56162339663E-03 1.59268115415E-03 1.62434650584E-03 1.65663092638E-03 1.68954609016E-03 1.72310387406E-03 1.75731636024E-03 1.79219583887E-03 1.82775481091E-03 1.86400599091E-03 1.90096230975E-03 1.93863691744E-03 1.97704318581E-03 2.01619471136E-03 2.05610531790E-03 2.09678905936E-03 2.13826022244E-03 2.18053332929E-03 2.22362314023E-03 2.26754465632E-03 2.31231312201E-03 2.35794402769E-03 2.40445311221E-03 2.45185636540E-03 2.50017003048E-03 2.54941060647E-03 2.59959485050E-03 2.65073978012E-03 2.70286267548E-03 2.75598108144E-03 2.81011280968E-03 2.86527594065E-03 2.92148882541E-03 2.97877008749E-03 3.03713862451E-03 3.09661360978E-03 3.15721449376E-03 3.21896100537E-03 3.28187315317E-03 3.34597122647E-03 3.41127579616E-03 3.47780771550E-03 3.54558812067E-03 3.61463843118E-03 3.68498035003E-03 3.75663586374E-03 3.82962724217E-03 3.90397703800E-03 3.97970808616E-03 4.05684350281E-03 4.13540668424E-03 4.21542130538E-03 4.29691131805E-03 4.37990094892E-03 4.46441469716E-03 4.55047733172E-03 4.63811388826E-03 4.72734966576E-03 4.81821022273E-03 4.91072137295E-03 5.00490918088E-03 5.10079995658E-03 5.19842025017E-03 5.29779684583E-03 5.39895675524E-03 5.50192721061E-03 5.60673565700E-03 5.71340974424E-03 5.82197731808E-03 5.93246641088E-03 6.04490523152E-03 6.15932215474E-03 6.27574570969E-03 6.39420456781E-03 6.51472752991E-03 6.63734351250E-03 6.76208153326E-03 6.88897069568E-03 7.01804017279E-03 7.14931919002E-03 7.28283700702E-03 7.41862289861E-03 7.55670613457E-03 7.69711595847E-03 7.83988156535E-03 7.98503207830E-03 8.13259652378E-03 8.28260380581E-03 8.43508267882E-03 8.59006171929E-03 8.74756929594E-03 8.90763353856E-03 9.07028230547E-03 9.23554314938E-03 9.40344328183E-03 9.57400953596E-03 9.74726832776E-03 9.92324561553E-03 1.01019668577E-02 1.02834569689E-02 1.04677402741E-02 1.06548404610E-02 1.08447805303E-02 1.10375827445E-02 1.12332685739E-02 1.14318586411E-02 1.16333726636E-02 1.18378293931E-02 1.20452465541E-02 1.22556407789E-02 1.24690275411E-02 1.26854210865E-02 1.29048343615E-02 1.31272789388E-02 1.33527649416E-02 1.35813009638E-02 1.38128939886E-02 1.40475493044E-02 1.42852704177E-02 1.45260589634E-02 1.47699146126E-02 1.50168349772E-02 1.52668155123E-02 1.55198494152E-02 1.57759275221E-02 1.60350382014E-02 1.62971672450E-02 1.65622977557E-02 1.68304100327E-02 1.71014814538E-02 1.73754863546E-02 1.76523959059E-02 1.79321779868E-02 1.82147970566E-02 1.85002140232E-02 1.87883861091E-02 1.90792667146E-02 1.93728052795E-02 1.96689471412E-02 1.99676333913E-02 2.02688007302E-02 2.05723813190E-02 2.08783026303E-02 2.11864872970E-02 2.14968529595E-02 2.18093121118E-02 2.21237719463E-02 2.24401341981E-02 2.27582949883E-02 2.30781446672E-02 2.33995676574E-02 2.37224422975E-02 2.40466406857E-02 2.43720285252E-02 2.46984649707E-02 2.50258024764E-02 2.53538866470E-02 2.56825560907E-02 2.60116422758E-02 2.63409693915E-02 2.66703542120E-02 2.69996059669E-02 2.73285262160E-02 2.76569087313E-02 2.79845393852E-02 2.83111960474E-02 2.86366484890E-02 2.89606582974E-02 2.92829787999E-02 2.96033549994E-02 2.99215235217E-02 3.02372125755E-02 3.05501419269E-02 3.08600228884E-02 3.11665583236E-02 3.14694426705E-02 3.17683619809E-02 3.20629939813E-02 3.23530081532E-02 3.26380658357E-02 3.29178203513E-02 3.31919171558E-02 3.34599940148E-02 3.37216812062E-02 3.39766017516E-02 3.42243716780E-02 3.44646003097E-02 3.46968905936E-02 3.49208394578E-02 3.51360382057E-02 3.53420729470E-02 3.55385250659E-02 3.57249717291E-02 3.59009864343E-02 3.60661396003E-02 3.62199991997E-02 3.63621314360E-02 3.64921014652E-02 3.66094741641E-02 3.67138149443E-02 3.68046906146E-02 3.68816702911E-02 3.69443263557E-02 3.69922354636E-02 3.70249796000E-02 3.70421471857E-02 3.70433342306E-02 3.70281455372E-02 3.69961959495E-02 3.69471116507E-02 3.68805315043E-02 3.67961084410E-02 3.66935108861E-02 3.65724242277E-02 3.64325523227E-02 3.62736190364E-02 3.60953698148E-02 3.58975732836E-02 3.56800228720E-02 3.54425384551E-02 3.51849680112E-02 3.49071892881E-02 3.46091114722E-02 3.42906768557E-02 3.39518624923E-02 3.35926818374E-02 3.32131863620E-02 3.28134671339E-02 3.23936563570E-02 3.19539288585E-02 3.14945035158E-02 3.10156446108E-02 3.05176631033E-02 3.00009178097E-02 2.94658164775E-02 2.89128167430E-02 2.83424269596E-02 2.77552068836E-02 2.71517682070E-02 2.65327749210E-02 2.58989435001E-02 2.52510428911E-02 2.45898942962E-02 2.39163707348E-02 2.32313963734E-02 2.25359456090E-02 2.18310418960E-02 2.11177563029E-02 2.03972057894E-02 1.96705511937E-02 1.89389949195E-02 1.82037783161E-02 1.74661787442E-02 1.67275063213E-02 1.59891003433E-02 1.52523253806E-02 1.45185670465E-02 1.37892274418E-02 1.30657202777E-02 1.23494656843E-02 1.16418847129E-02 1.09443935440E-02 1.02583974151E-02 9.58528428613E-03 8.92641826243E-03 8.28313279959E-03 7.65672371714E-03 7.04844205178E-03 6.45948678425E-03 5.89099747763E-03 5.34404686827E-03 4.81963345419E-03 4.31867412926E-03 3.84199691464E-03 3.39033384238E-03 2.96431404902E-03 2.56445713957E-03 2.19116688492E-03 1.84472531748E-03 1.52528729175E-03 1.23287557707E-03 9.67376550684E-04 7.28536558789E-04 5.15959012108E-04 3.29102280901E-04 1.67278451325E-04 2.96530013081E-05 -8.47545508154E-05 -1.77068977796E-04 -2.48556615283E-04 -3.00621542844E-04 -3.34800653097E-04 -3.52757599300E-04 -3.56275624641E-04 -3.47249290781E-04 -3.27675138970E-04 -2.99641334222E-04 -2.65316361466E-04 -2.26936862328E-04 -1.86794721867E-04 -1.47223536284E-04 -1.10584614817E-04 -7.89171848918E-05 -5.28508401274E-05 -3.24743478163E-05 -1.76275917520E-05 -7.87306768368E-06 -2.46633506907E-06 -3.25521839740E-07 -1.55878681459E-16 -2.62998204032E-17 -9.03266309511E-18 1.06833970351E-17 2.14600536960E-17 1.74505458016E-16 -9.57314702691E-18 2.04168795379E-17 1.62190887331E-16 2.12939234069E-17 -1.22068485770E-19 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1 2 0 i j (l(j)) 1.41448965967E-02 Q_int 2.72214987830E-06 2.77713917632E-06 2.83323925931E-06 2.89047256367E-06 2.94886197889E-06 3.00843085677E-06 3.06920302069E-06 3.13120277517E-06 3.19445491556E-06 3.25898473799E-06 3.32481804941E-06 3.39198117799E-06 3.46050098356E-06 3.53040486840E-06 3.60172078817E-06 3.67447726310E-06 3.74870338933E-06 3.82442885062E-06 3.90168393016E-06 3.98049952266E-06 4.06090714673E-06 4.14293895748E-06 4.22662775930E-06 4.31200701907E-06 4.39911087943E-06 4.48797417250E-06 4.57863243374E-06 4.67112191619E-06 4.76547960493E-06 4.86174323184E-06 4.95995129073E-06 5.06014305264E-06 5.16235858161E-06 5.26663875060E-06 5.37302525789E-06 5.48156064368E-06 5.59228830712E-06 5.70525252363E-06 5.82049846257E-06 5.93807220530E-06 6.05802076358E-06 6.18039209832E-06 6.30523513878E-06 6.43259980206E-06 6.56253701307E-06 6.69509872483E-06 6.83033793925E-06 6.96830872827E-06 7.10906625545E-06 7.25266679799E-06 7.39916776924E-06 7.54862774153E-06 7.70110646965E-06 7.85666491464E-06 8.01536526815E-06 8.17727097725E-06 8.34244676976E-06 8.51095868009E-06 8.68287407557E-06 8.85826168337E-06 9.03719161789E-06 9.21973540877E-06 9.40596602940E-06 9.59595792606E-06 9.78978704761E-06 9.98753087580E-06 1.01892684562E-05 1.03950804296E-05 1.06050490644E-05 1.08192582892E-05 1.10377937265E-05 1.12607427267E-05 1.14881944029E-05 1.17202396665E-05 1.19569712634E-05 1.21984838112E-05 1.24448738367E-05 1.26962398142E-05 1.29526822052E-05 1.32143034984E-05 1.34812082499E-05 1.37535031258E-05 1.40312969440E-05 1.43147007179E-05 1.46038277006E-05 1.48987934300E-05 1.51997157747E-05 1.55067149811E-05 1.58199137213E-05 1.61394371419E-05 1.64654129139E-05 1.67979712835E-05 1.71372451239E-05 1.74833699883E-05 1.78364841639E-05 1.81967287268E-05 1.85642475983E-05 1.89391876021E-05 1.93216985227E-05 1.97119331653E-05 2.01100474159E-05 2.05162003042E-05 2.09305540662E-05 2.13532742090E-05 2.17845295766E-05 2.22244924169E-05 2.26733384504E-05 2.31312469401E-05 2.35984007623E-05 2.40749864798E-05 2.45611944158E-05 2.50572187297E-05 2.55632574938E-05 2.60795127725E-05 2.66061907024E-05 2.71435015738E-05 2.76916599149E-05 2.82508845763E-05 2.88213988182E-05 2.94034303989E-05 2.99972116653E-05 3.06029796451E-05 3.12209761406E-05 3.18514478247E-05 3.24946463389E-05 3.31508283929E-05 3.38202558664E-05 3.45031959128E-05 3.51999210653E-05 3.59107093445E-05 3.66358443691E-05 3.73756154675E-05 3.81303177930E-05 3.89002524402E-05 3.96857265647E-05 4.04870535037E-05 4.13045529011E-05 4.21385508331E-05 4.29893799374E-05 4.38573795449E-05 4.47428958136E-05 4.56462818651E-05 4.65678979250E-05 4.75081114641E-05 4.84672973442E-05 4.94458379659E-05 5.04441234194E-05 5.14625516386E-05 5.25015285576E-05 5.35614682716E-05 5.46427931991E-05 5.57459342493E-05 5.68713309912E-05 5.80194318271E-05 5.91906941687E-05 6.03855846179E-05 6.16045791495E-05 6.28481632988E-05 6.41168323529E-05 6.54110915445E-05 6.67314562511E-05 6.80784521972E-05 6.94526156606E-05 7.08544936831E-05 7.22846442847E-05 7.37436366828E-05 7.52320515154E-05 7.67504810680E-05 7.82995295065E-05 7.98798131126E-05 8.14919605260E-05 8.31366129898E-05 8.48144246010E-05 8.65260625666E-05 8.82722074638E-05 9.00535535059E-05 9.18708088131E-05 9.37246956886E-05 9.56159509004E-05 9.75453259681E-05 9.95135874556E-05 1.01521517269E-04 1.03569912963E-04 1.05659588046E-04 1.07791372301E-04 1.09966112106E-04 1.12184670763E-04 1.14447928830E-04 1.16756784466E-04 1.19112153778E-04 1.21514971171E-04 1.23966189719E-04 1.26466781521E-04 1.29017738088E-04 1.31620070719E-04 1.34274810890E-04 1.36983010658E-04 1.39745743059E-04 1.42564102527E-04 1.45439205308E-04 1.48372189894E-04 1.51364217461E-04 1.54416472307E-04 1.57530162313E-04 1.60706519404E-04 1.63946800015E-04 1.67252285579E-04 1.70624283009E-04 1.74064125202E-04 1.77573171541E-04 1.81152808419E-04 1.84804449760E-04 1.88529537559E-04 1.92329542430E-04 1.96205964160E-04 2.00160332280E-04 2.04194206641E-04 2.08309178004E-04 2.12506868640E-04 2.16788932940E-04 2.21157058039E-04 2.25612964450E-04 2.30158406707E-04 2.34795174026E-04 2.39525090971E-04 2.44350018141E-04 2.49271852856E-04 2.54292529874E-04 2.59414022102E-04 2.64638341335E-04 2.69967538999E-04 2.75403706910E-04 2.80948978052E-04 2.86605527358E-04 2.92375572515E-04 2.98261374780E-04 3.04265239808E-04 3.10389518499E-04 3.16636607856E-04 3.23008951860E-04 3.29509042364E-04 3.36139419996E-04 3.42902675079E-04 3.49801448574E-04 3.56838433030E-04 3.64016373559E-04 3.71338068819E-04 3.78806372020E-04 3.86424191948E-04 3.94194494000E-04 4.02120301244E-04 4.10204695492E-04 4.18450818393E-04 4.26861872542E-04 4.35441122613E-04 4.44191896502E-04 4.53117586499E-04 4.62221650469E-04 4.71507613063E-04 4.80979066937E-04 4.90639674001E-04 5.00493166681E-04 5.10543349205E-04 5.20794098907E-04 5.31249367556E-04 5.41913182695E-04 5.52789649015E-04 5.63882949741E-04 5.75197348040E-04 5.86737188453E-04 5.98506898345E-04 6.10510989384E-04 6.22754059031E-04 6.35240792059E-04 6.47975962094E-04 6.60964433178E-04 6.74211161346E-04 6.87721196242E-04 7.01499682737E-04 7.15551862588E-04 7.29883076108E-04 7.44498763861E-04 7.59404468381E-04 7.74605835912E-04 7.90108618174E-04 8.05918674144E-04 8.22041971865E-04 8.38484590278E-04 8.55252721071E-04 8.72352670555E-04 8.89790861558E-04 9.07573835344E-04 9.25708253550E-04 9.44200900147E-04 9.63058683417E-04 9.82288637961E-04 1.00189792671E-03 1.02189384298E-03 1.04228381252E-03 1.06307539560E-03 1.08427628909E-03 1.10589432861E-03 1.12793749062E-03 1.15041389461E-03 1.17333180525E-03 1.19669963455E-03 1.22052594408E-03 1.24481944718E-03 1.26958901116E-03 1.29484365955E-03 1.32059257434E-03 1.34684509823E-03 1.37361073688E-03 1.40089916120E-03 1.42872020962E-03 1.45708389034E-03 1.48600038366E-03 1.51548004420E-03 1.54553340324E-03 1.57617117096E-03 1.60740423873E-03 1.63924368139E-03 1.67170075948E-03 1.70478692152E-03 1.73851380621E-03 1.77289324469E-03 1.80793726274E-03 1.84365808293E-03 1.88006812681E-03 1.91718001702E-03 1.95500657944E-03 1.99356084519E-03 2.03285605271E-03 2.07290564976E-03 2.11372329533E-03 2.15532286160E-03 2.19771843571E-03 2.24092432164E-03 2.28495504189E-03 2.32982533915E-03 2.37555017791E-03 2.42214474598E-03 2.46962445592E-03 2.51800494638E-03 2.56730208341E-03 2.61753196153E-03 2.66871090487E-03 2.72085546805E-03 2.77398243705E-03 2.82810882984E-03 2.88325189700E-03 2.93942912211E-03 2.99665822200E-03 3.05495714687E-03 3.11434408023E-03 3.17483743867E-03 3.23645587139E-03 3.29921825959E-03 3.36314371569E-03 3.42825158217E-03 3.49456143038E-03 3.56209305897E-03 3.63086649209E-03 3.70090197739E-03 3.77221998366E-03 3.84484119821E-03 3.91878652394E-03 3.99407707609E-03 4.07073417867E-03 4.14877936047E-03 4.22823435078E-03 4.30912107469E-03 4.39146164799E-03 4.47527837162E-03 4.56059372575E-03 4.64743036331E-03 4.73581110314E-03 4.82575892255E-03 4.91729694941E-03 5.01044845371E-03 5.10523683854E-03 5.20168563041E-03 5.29981846914E-03 5.39965909690E-03 5.50123134677E-03 5.60455913050E-03 5.70966642559E-03 5.81657726168E-03 5.92531570609E-03 6.03590584862E-03 6.14837178551E-03 6.26273760256E-03 6.37902735730E-03 6.49726506035E-03 6.61747465572E-03 6.73968000023E-03 6.86390484178E-03 6.99017279676E-03 7.11850732614E-03 7.24893171066E-03 7.38146902470E-03 7.51614210904E-03 7.65297354235E-03 7.79198561143E-03 7.93320028012E-03 8.07663915687E-03 8.22232346091E-03 8.37027398702E-03 8.52051106877E-03 8.67305454032E-03 8.82792369661E-03 8.98513725198E-03 9.14471329715E-03 9.30666925454E-03 9.47102183181E-03 9.63778697374E-03 9.80697981221E-03 9.97861461439E-03 1.01527047290E-02 1.03292625309E-02 1.05082993630E-02 1.06898254773E-02 1.08738499728E-02 1.10603807319E-02 1.12494243550E-02 1.14409860918E-02 1.16350697718E-02 1.18316777318E-02 1.20308107414E-02 1.22324679259E-02 1.24366466877E-02 1.26433426248E-02 1.28525494469E-02 1.30642588895E-02 1.32784606260E-02 1.34951421764E-02 1.37142888149E-02 1.39358834741E-02 1.41599066480E-02 1.43863362914E-02 1.46151477184E-02 1.48463134976E-02 1.50798033455E-02 1.53155840177E-02 1.55536191984E-02 1.57938693870E-02 1.60362917835E-02 1.62808401716E-02 1.65274648002E-02 1.67761122629E-02 1.70267253766E-02 1.72792430577E-02 1.75336001977E-02 1.77897275376E-02 1.80475515407E-02 1.83069942654E-02 1.85679732367E-02 1.88304013179E-02 1.90941865817E-02 1.93592321814E-02 1.96254362231E-02 1.98926916374E-02 2.01608860532E-02 2.04299016723E-02 2.06996151457E-02 2.09698974516E-02 2.12406137766E-02 2.15116233991E-02 2.17827795764E-02 2.20539294354E-02 2.23249138676E-02 2.25955674292E-02 2.28657182463E-02 2.31351879260E-02 2.34037914748E-02 2.36713372234E-02 2.39376267602E-02 2.42024548725E-02 2.44656094983E-02 2.47268716873E-02 2.49860155733E-02 2.52428083586E-02 2.54970103100E-02 2.57483747700E-02 2.59966481811E-02 2.62415701263E-02 2.64828733851E-02 2.67202840084E-02 2.69535214101E-02 2.71822984793E-02 2.74063217129E-02 2.76252913690E-02 2.78389016439E-02 2.80468408728E-02 2.82487917548E-02 2.84444316045E-02 2.86334326307E-02 2.88154622431E-02 2.89901833889E-02 2.91572549192E-02 2.93163319875E-02 2.94670664808E-02 2.96091074837E-02 2.97421017782E-02 2.98656943777E-02 2.99795290983E-02 3.00832491673E-02 3.01764978687E-02 3.02589192284E-02 3.03301587376E-02 3.03898641161E-02 3.04376861157E-02 3.04732793625E-02 3.04963032409E-02 3.05064228160E-02 3.05033097967E-02 3.04866435372E-02 3.04561120775E-02 3.04114132216E-02 3.03522556514E-02 3.02783600764E-02 3.01894604171E-02 3.00853050191E-02 2.99656578976E-02 2.98303000082E-02 2.96790305419E-02 2.95116682416E-02 2.93280527355E-02 2.91280458841E-02 2.89115331375E-02 2.86784248965E-02 2.84286578743E-02 2.81621964522E-02 2.78790340244E-02 2.75791943247E-02 2.72627327300E-02 2.69297375313E-02 2.65803311676E-02 2.62146714124E-02 2.58329525058E-02 2.54354062233E-02 2.50223028730E-02 2.45939522104E-02 2.41507042626E-02 2.36929500514E-02 2.32211222055E-02 2.27356954504E-02 2.22371869673E-02 2.17261566081E-02 2.12032069580E-02 2.06689832334E-02 2.01241730052E-02 1.95695057367E-02 1.90057521266E-02 1.84337232458E-02 1.78542694595E-02 1.72682791261E-02 1.66766770627E-02 1.60804227711E-02 1.54805084175E-02 1.48779565586E-02 1.42738176114E-02 1.36691670615E-02 1.30651024085E-02 1.24627398484E-02 1.18632106928E-02 1.12676575288E-02 1.06772301233E-02 1.00930810803E-02 9.51636125754E-03 8.94821495627E-03 8.38977489645E-03 7.84215699425E-03 7.30645496068E-03 6.78373474308E-03 6.27502883408E-03 5.78133047536E-03 5.30358778663E-03 4.84269785293E-03 4.39950080657E-03 3.97477394249E-03 3.56922590891E-03 3.18349101761E-03 2.81812372065E-03 2.47359330267E-03 2.15027883997E-03 1.84846447901E-03 1.56833508872E-03 1.30997234157E-03 1.07335127897E-03 8.58337416442E-04 6.64684443213E-04 4.92032569659E-04 3.39907573689E-04 2.07720594367E-04 9.47687172324E-05 2.36390997375E-07 -7.68022903696E-05 -1.37380412962E-04 -1.82634156267E-04 -2.13797784068E-04 -2.32197712548E-04 -2.39245666420E-04 -2.36430946217E-04 -2.25311843250E-04 -2.07506253128E-04 -1.84681554060E-04 -1.58543832247E-04 -1.30826553427E-04 -1.03278796862E-04 -7.76531854517E-05 -5.54525068493E-05 -3.71517879233E-05 -2.28322286040E-05 -1.23933908006E-05 -5.53409315690E-06 -1.73294116089E-06 -2.28608075580E-07 -1.03433530070E-16 -1.27570222054E-17 -1.70482253994E-17 -4.23622359830E-18 -9.82917152831E-18 6.90159630427E-17 1.81516827700E-17 2.74187992476E-19 7.55052926824E-17 1.03391087950E-17 1.25456923309E-17 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2 2 0 i j (l(j)) 1.16369057316E-02 Q_int 2.25606681484E-06 2.30164090316E-06 2.34813558856E-06 2.39556946586E-06 2.44396150540E-06 2.49333106069E-06 2.54369787605E-06 2.59508209458E-06 2.64750426617E-06 2.70098535571E-06 2.75554675149E-06 2.81121027375E-06 2.86799818336E-06 2.92593319078E-06 2.98503846508E-06 3.04533764323E-06 3.10685483951E-06 3.16961465520E-06 3.23364218838E-06 3.29896304394E-06 3.36560334385E-06 3.43358973758E-06 3.50294941274E-06 3.57371010596E-06 3.64590011393E-06 3.71954830479E-06 3.79468412958E-06 3.87133763403E-06 3.94953947059E-06 4.02932091064E-06 4.11071385702E-06 4.19375085674E-06 4.27846511399E-06 4.36489050341E-06 4.45306158361E-06 4.54301361101E-06 4.63478255387E-06 4.72840510668E-06 4.82391870482E-06 4.92136153950E-06 5.02077257304E-06 5.12219155437E-06 5.22565903498E-06 5.33121638505E-06 5.43890580999E-06 5.54877036731E-06 5.66085398380E-06 5.77520147305E-06 5.89185855337E-06 6.01087186603E-06 6.13228899389E-06 6.25615848035E-06 6.38252984882E-06 6.51145362238E-06 6.64298134403E-06 6.77716559722E-06 6.91406002685E-06 7.05371936069E-06 7.19619943119E-06 7.34155719780E-06 7.48985076966E-06 7.64113942881E-06 7.79548365386E-06 7.95294514409E-06 8.11358684405E-06 8.27747296873E-06 8.44466902915E-06 8.61524185844E-06 8.78925963860E-06 8.96679192761E-06 9.14790968720E-06 9.33268531115E-06 9.52119265417E-06 9.71350706135E-06 9.90970539816E-06 1.01098660812E-05 1.03140691092E-05 1.05223960954E-05 1.07349302996E-05 1.09517566616E-05 1.11729618348E-05 1.13986342212E-05 1.16288640063E-05 1.18637431948E-05 1.21033656480E-05 1.23478271204E-05 1.25972252983E-05 1.28516598387E-05 1.31112324087E-05 1.33760467263E-05 1.36462086017E-05 1.39218259792E-05 1.42030089803E-05 1.44898699476E-05 1.47825234896E-05 1.50810865259E-05 1.53856783343E-05 1.56964205980E-05 1.60134374538E-05 1.63368555421E-05 1.66668040566E-05 1.70034147960E-05 1.73468222167E-05 1.76971634857E-05 1.80545785357E-05 1.84192101203E-05 1.87912038711E-05 1.91707083554E-05 1.95578751353E-05 1.99528588279E-05 2.03558171667E-05 2.07669110646E-05 2.11863046774E-05 2.16141654690E-05 2.20506642785E-05 2.24959753873E-05 2.29502765888E-05 2.34137492588E-05 2.38865784272E-05 2.43689528522E-05 2.48610650944E-05 2.53631115936E-05 2.58752927467E-05 2.63978129871E-05 2.69308808657E-05 2.74747091338E-05 2.80295148271E-05 2.85955193520E-05 2.91729485734E-05 2.97620329038E-05 3.03630073948E-05 3.09761118303E-05 3.16015908210E-05 3.22396939020E-05 3.28906756305E-05 3.35547956875E-05 3.42323189800E-05 3.49235157458E-05 3.56286616606E-05 3.63480379467E-05 3.70819314842E-05 3.78306349245E-05 3.85944468058E-05 3.93736716709E-05 4.01686201877E-05 4.09796092715E-05 4.18069622102E-05 4.26510087920E-05 4.35120854351E-05 4.43905353207E-05 4.52867085280E-05 4.62009621723E-05 4.71336605456E-05 4.80851752599E-05 4.90558853938E-05 5.00461776416E-05 5.10564464651E-05 5.20870942491E-05 5.31385314595E-05 5.42111768043E-05 5.53054573987E-05 5.64218089322E-05 5.75606758400E-05 5.87225114773E-05 5.99077782969E-05 6.11169480311E-05 6.23505018758E-05 6.36089306797E-05 6.48927351362E-05 6.62024259794E-05 6.75385241837E-05 6.89015611681E-05 7.02920790035E-05 7.17106306243E-05 7.31577800451E-05 7.46341025800E-05 7.61401850674E-05 7.76766260989E-05 7.92440362526E-05 8.08430383306E-05 8.24742676019E-05 8.41383720491E-05 8.58360126208E-05 8.75678634882E-05 8.93346123071E-05 9.11369604845E-05 9.29756234513E-05 9.48513309390E-05 9.67648272628E-05 9.87168716098E-05 1.00708238332E-04 1.02739717248E-04 1.04812113944E-04 1.06926250090E-04 1.09082963751E-04 1.11283109716E-04 1.13527559823E-04 1.15817203297E-04 1.18152947091E-04 1.20535716233E-04 1.22966454186E-04 1.25446123203E-04 1.27975704703E-04 1.30556199642E-04 1.33188628898E-04 1.35874033660E-04 1.38613475828E-04 1.41408038416E-04 1.44258825964E-04 1.47166964963E-04 1.50133604279E-04 1.53159915592E-04 1.56247093838E-04 1.59396357667E-04 1.62608949900E-04 1.65886138001E-04 1.69229214557E-04 1.72639497764E-04 1.76118331924E-04 1.79667087953E-04 1.83287163896E-04 1.86979985448E-04 1.90747006496E-04 1.94589709659E-04 1.98509606840E-04 2.02508239797E-04 2.06587180714E-04 2.10748032787E-04 2.14992430820E-04 2.19322041833E-04 2.23738565679E-04 2.28243735674E-04 2.32839319234E-04 2.37527118532E-04 2.42308971158E-04 2.47186750796E-04 2.52162367911E-04 2.57237770446E-04 2.62414944539E-04 2.67695915244E-04 2.73082747270E-04 2.78577545727E-04 2.84182456897E-04 2.89899669003E-04 2.95731413003E-04 3.01679963393E-04 3.07747639025E-04 3.13936803936E-04 3.20249868197E-04 3.26689288770E-04 3.33257570385E-04 3.39957266429E-04 3.46790979848E-04 3.53761364070E-04 3.60871123935E-04 3.68123016650E-04 3.75519852752E-04 3.83064497089E-04 3.90759869819E-04 3.98608947422E-04 4.06614763732E-04 4.14780410982E-04 4.23109040866E-04 4.31603865619E-04 4.40268159119E-04 4.49105257990E-04 4.58118562743E-04 4.67311538921E-04 4.76687718261E-04 4.86250699883E-04 4.96004151487E-04 5.05951810577E-04 5.16097485691E-04 5.26445057660E-04 5.36998480883E-04 5.47761784614E-04 5.58739074274E-04 5.69934532778E-04 5.81352421883E-04 5.92997083549E-04 6.04872941326E-04 6.16984501756E-04 6.29336355789E-04 6.41933180224E-04 6.54779739167E-04 6.67880885504E-04 6.81241562399E-04 6.94866804798E-04 7.08761740968E-04 7.22931594038E-04 7.37381683567E-04 7.52117427132E-04 7.67144341920E-04 7.82468046355E-04 7.98094261727E-04 8.14028813848E-04 8.30277634719E-04 8.46846764214E-04 8.63742351782E-04 8.80970658162E-04 8.98538057114E-04 9.16451037164E-04 9.34716203362E-04 9.53340279059E-04 9.72330107689E-04 9.91692654566E-04 1.01143500870E-03 1.03156438460E-03 1.05208812413E-03 1.07301369834E-03 1.09434870928E-03 1.11610089192E-03 1.13827811595E-03 1.16088838769E-03 1.18393985193E-03 1.20744079384E-03 1.23139964079E-03 1.25582496430E-03 1.28072548185E-03 1.30611005880E-03 1.33198771021E-03 1.35836760276E-03 1.38525905656E-03 1.41267154702E-03 1.44061470668E-03 1.46909832703E-03 1.49813236032E-03 1.52772692132E-03 1.55789228914E-03 1.58863890893E-03 1.61997739362E-03 1.65191852561E-03 1.68447325843E-03 1.71765271836E-03 1.75146820601E-03 1.78593119790E-03 1.82105334794E-03 1.85684648888E-03 1.89332263375E-03 1.93049397715E-03 1.96837289660E-03 2.00697195373E-03 2.04630389543E-03 2.08638165496E-03 2.12721835295E-03 2.16882729828E-03 2.21122198896E-03 2.25441611284E-03 2.29842354824E-03 2.34325836452E-03 2.38893482243E-03 2.43546737444E-03 2.48287066494E-03 2.53115953021E-03 2.58034899834E-03 2.63045428899E-03 2.68149081297E-03 2.73347417163E-03 2.78642015613E-03 2.84034474651E-03 2.89526411054E-03 2.95119460239E-03 3.00815276107E-03 3.06615530869E-03 3.12521914843E-03 3.18536136229E-03 3.24659920857E-03 3.30895011913E-03 3.37243169628E-03 3.43706170945E-03 3.50285809151E-03 3.56983893481E-03 3.63802248681E-03 3.70742714543E-03 3.77807145399E-03 3.84997409582E-03 3.92315388836E-03 3.99762977699E-03 4.07342082828E-03 4.15054622292E-03 4.22902524808E-03 4.30887728934E-03 4.39012182206E-03 4.47277840229E-03 4.55686665703E-03 4.64240627405E-03 4.72941699099E-03 4.81791858390E-03 4.90793085517E-03 4.99947362073E-03 5.09256669660E-03 5.18722988475E-03 5.28348295816E-03 5.38134564518E-03 5.48083761304E-03 5.58197845059E-03 5.68478765018E-03 5.78928458863E-03 5.89548850735E-03 6.00341849149E-03 6.11309344813E-03 6.22453208350E-03 6.33775287913E-03 6.45277406699E-03 6.56961360349E-03 6.68828914245E-03 6.80881800675E-03 6.93121715898E-03 7.05550317076E-03 7.18169219078E-03 7.30979991166E-03 7.43984153540E-03 7.57183173746E-03 7.70578462956E-03 7.84171372090E-03 7.97963187806E-03 8.11955128332E-03 8.26148339147E-03 8.40543888512E-03 8.55142762829E-03 8.69945861856E-03 8.84953993737E-03 9.00167869877E-03 9.15588099644E-03 9.31215184890E-03 9.47049514302E-03 9.63091357572E-03 9.79340859387E-03 9.95798033227E-03 1.01246275499E-02 1.02933475643E-02 1.04641361839E-02 1.06369876384E-02 1.08118945078E-02 1.09888476489E-02 1.11678361200E-02 1.13488471040E-02 1.15318658293E-02 1.17168754889E-02 1.19038571576E-02 1.20927897074E-02 1.22836497213E-02 1.24764114047E-02 1.26710464955E-02 1.28675241725E-02 1.30658109621E-02 1.32658706432E-02 1.34676641509E-02 1.36711494786E-02 1.38762815785E-02 1.40830122615E-02 1.42912900954E-02 1.45010603021E-02 1.47122646542E-02 1.49248413709E-02 1.51387250125E-02 1.53538463758E-02 1.55701323882E-02 1.57875060020E-02 1.60058860892E-02 1.62251873365E-02 1.64453201408E-02 1.66661905058E-02 1.68876999398E-02 1.71097453549E-02 1.73322189680E-02 1.75550082045E-02 1.77779956031E-02 1.80010587253E-02 1.82240700670E-02 1.84468969741E-02 1.86694015625E-02 1.88914406424E-02 1.91128656481E-02 1.93335225732E-02 1.95532519122E-02 1.97718886083E-02 1.99892620098E-02 2.02051958332E-02 2.04195081355E-02 2.06320112956E-02 2.08425120063E-02 2.10508112761E-02 2.12567044431E-02 2.14599812006E-02 2.16604256364E-02 2.18578162850E-02 2.20519261953E-02 2.22425230134E-02 2.24293690812E-02 2.26122215534E-02 2.27908325315E-02 2.29649492175E-02 2.31343140871E-02 2.32986650840E-02 2.34577358358E-02 2.36112558929E-02 2.37589509902E-02 2.39005433344E-02 2.40357519156E-02 2.41642928460E-02 2.42858797247E-02 2.44002240316E-02 2.45070355492E-02 2.46060228136E-02 2.46968935961E-02 2.47793554157E-02 2.48531160818E-02 2.49178842698E-02 2.49733701281E-02 2.50192859179E-02 2.50553466855E-02 2.50812709671E-02 2.50967815271E-02 2.51016061277E-02 2.50954783318E-02 2.50781383369E-02 2.50493338405E-02 2.50088209357E-02 2.49563650357E-02 2.48917418268E-02 2.48147382476E-02 2.47251534933E-02 2.46228000428E-02 2.45075047069E-02 2.43791096941E-02 2.42374736934E-02 2.40824729680E-02 2.39140024599E-02 2.37319768991E-02 2.35363319151E-02 2.33270251455E-02 2.31040373384E-02 2.28673734413E-02 2.26170636743E-02 2.23531645797E-02 2.20757600425E-02 2.17849622768E-02 2.14809127697E-02 2.11637831775E-02 2.08337761656E-02 2.04911261858E-02 2.01361001821E-02 1.97689982185E-02 1.93901540187E-02 1.89999354118E-02 1.85987446723E-02 1.81870187490E-02 1.77652293720E-02 1.73338830298E-02 1.68935208077E-02 1.64447180794E-02 1.59880840423E-02 1.55242610896E-02 1.50539240114E-02 1.45777790150E-02 1.40965625614E-02 1.36110400081E-02 1.31220040541E-02 1.26302729825E-02 1.21366886951E-02 1.16421145379E-02 1.11474329136E-02 1.06535426820E-02 1.01613563471E-02 9.67179703482E-03 9.18579526294E-03 8.70428550984E-03 8.22820258825E-03 7.75847783304E-03 7.29603511390E-03 6.84178668565E-03 6.39662889130E-03 5.96143773505E-03 5.53706434490E-03 5.12433034649E-03 4.72402317276E-03 4.33689133574E-03 3.96363968970E-03 3.60492471680E-03 3.26134986889E-03 2.93346100121E-03 2.62174193571E-03 2.32661019363E-03 2.04841293876E-03 1.78742317387E-03 1.54383623443E-03 1.31776662408E-03 1.10924523701E-03 9.18217012237E-04 7.44539064287E-04 5.87979333797E-04 4.48215799809E-04 3.24836293310E-04 2.17338948553E-04 1.25133324990E-04 4.75422281244E-05 -1.61957477305E-05 -6.69229379774E-05 -1.05558577808E-04 -1.33094022002E-04 -1.50587221474E-04 -1.59156473257E-04 -1.59973471146E-04 -1.54255695494E-04 -1.43258192681E-04 -1.28264807320E-04 -1.10578943377E-04 -9.15139437018E-05 -7.23831910147E-05 -5.44900467478E-05 -3.89444185088E-05 -2.61064470793E-05 -1.60490323270E-05 -8.71205648305E-06 -3.88966790537E-06 -1.21758657693E-06 -1.60545961372E-07 -5.52942867350E-17 2.57733894639E-18 2.15795446594E-18 -1.28489348414E-17 5.10396061967E-18 -7.96957998258E-18 -5.67928853079E-18 4.80279747570E-18 1.31284848767E-18 1.18716479974E-17 -6.07089309983E-18 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1S 0 1.00 Wavefunction 3.56056904147E-03 3.59635300120E-03 3.63249658492E-03 3.66900340658E-03 3.70587711646E-03 3.74312140148E-03 3.78073998563E-03 3.81873663031E-03 3.85711513470E-03 3.89587933618E-03 3.93503311065E-03 3.97458037298E-03 4.01452507734E-03 4.05487121766E-03 4.09562282797E-03 4.13678398285E-03 4.17835879781E-03 4.22035142969E-03 4.26276607712E-03 4.30560698088E-03 4.34887842438E-03 4.39258473405E-03 4.43673027979E-03 4.48131947540E-03 4.52635677901E-03 4.57184669354E-03 4.61779376717E-03 4.66420259374E-03 4.71107781325E-03 4.75842411232E-03 4.80624622462E-03 4.85454893140E-03 4.90333706194E-03 4.95261549401E-03 5.00238915440E-03 5.05266301938E-03 5.10344211520E-03 5.15473151860E-03 5.20653635733E-03 5.25886181062E-03 5.31171310975E-03 5.36509553853E-03 5.41901443383E-03 5.47347518616E-03 5.52848324013E-03 5.58404409507E-03 5.64016330552E-03 5.69684648182E-03 5.75409929066E-03 5.81192745562E-03 5.87033675780E-03 5.92933303633E-03 5.98892218900E-03 6.04911017281E-03 6.10990300461E-03 6.17130676165E-03 6.23332758222E-03 6.29597166626E-03 6.35924527597E-03 6.42315473640E-03 6.48770643617E-03 6.55290682800E-03 6.61876242943E-03 6.68527982345E-03 6.75246565914E-03 6.82032665232E-03 6.88886958629E-03 6.95810131240E-03 7.02802875084E-03 7.09865889126E-03 7.16999879346E-03 7.24205558816E-03 7.31483647763E-03 7.38834873648E-03 7.46259971232E-03 7.53759682653E-03 7.61334757500E-03 7.68985952885E-03 7.76714033521E-03 7.84519771796E-03 7.92403947853E-03 8.00367349662E-03 8.08410773105E-03 8.16535022050E-03 8.24740908435E-03 8.33029252345E-03 8.41400882096E-03 8.49856634316E-03 8.58397354030E-03 8.67023894742E-03 8.75737118521E-03 8.84537896086E-03 8.93427106893E-03 9.02405639222E-03 9.11474390266E-03 9.20634266220E-03 9.29886182370E-03 9.39231063184E-03 9.48669842404E-03 9.58203463141E-03 9.67832877965E-03 9.77559049002E-03 9.87382948028E-03 9.97305556565E-03 1.00732786598E-02 1.01745087759E-02 1.02767560274E-02 1.03800306292E-02 1.04843428988E-02 1.05897032570E-02 1.06961222291E-02 1.08036104459E-02 1.09121786450E-02 1.10218376715E-02 1.11325984790E-02 1.12444721314E-02 1.13574698031E-02 1.14716027806E-02 1.15868824637E-02 1.17033203663E-02 1.18209281176E-02 1.19397174636E-02 1.20597002678E-02 1.21808885126E-02 1.23032943006E-02 1.24269298555E-02 1.25518075235E-02 1.26779397745E-02 1.28053392033E-02 1.29340185309E-02 1.30639906056E-02 1.31952684046E-02 1.33278650348E-02 1.34617937345E-02 1.35970678744E-02 1.37337009593E-02 1.38717066290E-02 1.40110986600E-02 1.41518909666E-02 1.42940976024E-02 1.44377327615E-02 1.45828107803E-02 1.47293461386E-02 1.48773534609E-02 1.50268475182E-02 1.51778432291E-02 1.53303556616E-02 1.54844000342E-02 1.56399917179E-02 1.57971462372E-02 1.59558792717E-02 1.61162066581E-02 1.62781443911E-02 1.64417086254E-02 1.66069156773E-02 1.67737820259E-02 1.69423243150E-02 1.71125593550E-02 1.72845041238E-02 1.74581757692E-02 1.76335916101E-02 1.78107691384E-02 1.79897260207E-02 1.81704800998E-02 1.83530493969E-02 1.85374521127E-02 1.87237066299E-02 1.89118315144E-02 1.91018455173E-02 1.92937675769E-02 1.94876168202E-02 1.96834125652E-02 1.98811743221E-02 2.00809217960E-02 2.02826748881E-02 2.04864536981E-02 2.06922785259E-02 2.09001698736E-02 2.11101484476E-02 2.13222351604E-02 2.15364511327E-02 2.17528176955E-02 2.19713563922E-02 2.21920889803E-02 2.24150374340E-02 2.26402239460E-02 2.28676709297E-02 2.30974010211E-02 2.33294370816E-02 2.35638021996E-02 2.38005196928E-02 2.40396131107E-02 2.42811062366E-02 2.45250230898E-02 2.47713879282E-02 2.50202252503E-02 2.52715597978E-02 2.55254165575E-02 2.57818207644E-02 2.60407979031E-02 2.63023737113E-02 2.65665741812E-02 2.68334255629E-02 2.71029543660E-02 2.73751873627E-02 2.76501515902E-02 2.79278743528E-02 2.82083832253E-02 2.84917060548E-02 2.87778709634E-02 2.90669063515E-02 2.93588408996E-02 2.96537035714E-02 2.99515236165E-02 3.02523305730E-02 3.05561542701E-02 3.08630248313E-02 3.11729726766E-02 3.14860285259E-02 3.18022234014E-02 3.21215886304E-02 3.24441558486E-02 3.27699570027E-02 3.30990243532E-02 3.34313904777E-02 3.37670882734E-02 3.41061509606E-02 3.44486120852E-02 3.47945055223E-02 3.51438654785E-02 3.54967264959E-02 3.58531234543E-02 3.62130915750E-02 3.65766664235E-02 3.69438839129E-02 3.73147803072E-02 3.76893922241E-02 3.80677566387E-02 3.84499108864E-02 3.88358926665E-02 3.92257400453E-02 3.96194914593E-02 4.00171857189E-02 4.04188620117E-02 4.08245599055E-02 4.12343193524E-02 4.16481806915E-02 4.20661846528E-02 4.24883723609E-02 4.29147853379E-02 4.33454655073E-02 4.37804551975E-02 4.42197971454E-02 4.46635345001E-02 4.51117108260E-02 4.55643701070E-02 4.60215567501E-02 4.64833155886E-02 4.69496918862E-02 4.74207313409E-02 4.78964800880E-02 4.83769847046E-02 4.88622922130E-02 4.93524500843E-02 4.98475062429E-02 5.03475090693E-02 5.08525074050E-02 5.13625505554E-02 5.18776882944E-02 5.23979708677E-02 5.29234489972E-02 5.34541738845E-02 5.39901972150E-02 5.45315711619E-02 5.50783483900E-02 5.56305820596E-02 5.61883258307E-02 5.67516338666E-02 5.73205608384E-02 5.78951619284E-02 5.84754928347E-02 5.90616097745E-02 5.96535694887E-02 6.02514292456E-02 6.08552468450E-02 6.14650806223E-02 6.20809894522E-02 6.27030327530E-02 6.33312704904E-02 6.39657631819E-02 6.46065719002E-02 6.52537582777E-02 6.59073845100E-02 6.65675133604E-02 6.72342081636E-02 6.79075328294E-02 6.85875518472E-02 6.92743302895E-02 6.99679338157E-02 7.06684286765E-02 7.13758817173E-02 7.20903603820E-02 7.28119327173E-02 7.35406673760E-02 7.42766336210E-02 7.50199013288E-02 7.57705409935E-02 7.65286237300E-02 7.72942212782E-02 7.80674060060E-02 7.88482509131E-02 7.96368296345E-02 8.04332164438E-02 8.12374862565E-02 8.20497146336E-02 8.28699777845E-02 8.36983525704E-02 8.45349165073E-02 8.53797477692E-02 8.62329251908E-02 8.70945282707E-02 8.79646371739E-02 8.88433327349E-02 8.97306964598E-02 9.06268105293E-02 9.15317578010E-02 9.24456218116E-02 9.33684867793E-02 9.43004376056E-02 9.52415598777E-02 9.61919398700E-02 9.71516645461E-02 9.81208215603E-02 9.90994992587E-02 1.00087786681E-01 1.01085773562E-01 1.02093550331E-01 1.03111208114E-01 1.04138838734E-01 1.05176534713E-01 1.06224389268E-01 1.07282496316E-01 1.08350950471E-01 1.09429847043E-01 1.10519282041E-01 1.11619352169E-01 1.12730154826E-01 1.13851788104E-01 1.14984350790E-01 1.16127942357E-01 1.17282662970E-01 1.18448613479E-01 1.19625895417E-01 1.20814610996E-01 1.22014863109E-01 1.23226755319E-01 1.24450391860E-01 1.25685877632E-01 1.26933318195E-01 1.28192819764E-01 1.29464489205E-01 1.30748434030E-01 1.32044762388E-01 1.33353583058E-01 1.34675005446E-01 1.36009139574E-01 1.37356096074E-01 1.38715986176E-01 1.40088921704E-01 1.41475015062E-01 1.42874379227E-01 1.44287127738E-01 1.45713374680E-01 1.47153234680E-01 1.48606822890E-01 1.50074254972E-01 1.51555647090E-01 1.53051115891E-01 1.54560778491E-01 1.56084752461E-01 1.57623155807E-01 1.59176106956E-01 1.60743724736E-01 1.62326128358E-01 1.63923437397E-01 1.65535771768E-01 1.67163251709E-01 1.68805997754E-01 1.70464130716E-01 1.72137771655E-01 1.73827041858E-01 1.75532062811E-01 1.77252956173E-01 1.78989843744E-01 1.80742847441E-01 1.82512089260E-01 1.84297691252E-01 1.86099775482E-01 1.87918464003E-01 1.89753878812E-01 1.91606141819E-01 1.93475374806E-01 1.95361699389E-01 1.97265236973E-01 1.99186108714E-01 2.01124435474E-01 2.03080337770E-01 2.05053935735E-01 2.07045349063E-01 2.09054696960E-01 2.11082098092E-01 2.13127670532E-01 2.15191531701E-01 2.17273798312E-01 2.19374586312E-01 2.21494010817E-01 2.23632186050E-01 2.25789225276E-01 2.27965240733E-01 2.30160343562E-01 2.32374643735E-01 2.34608249981E-01 2.36861269707E-01 2.39133808924E-01 2.41425972159E-01 2.43737862375E-01 2.46069580883E-01 2.48421227254E-01 2.50792899224E-01 2.53184692604E-01 2.55596701179E-01 2.58029016608E-01 2.60481728323E-01 2.62954923422E-01 2.65448686559E-01 2.67963099834E-01 2.70498242673E-01 2.73054191717E-01 2.75631020694E-01 2.78228800295E-01 2.80847598049E-01 2.83487478187E-01 2.86148501510E-01 2.88830725247E-01 2.91534202915E-01 2.94258984171E-01 2.97005114664E-01 2.99772635877E-01 3.02561584977E-01 3.05371994645E-01 3.08203892917E-01 3.11057303010E-01 3.13932243151E-01 3.16828726401E-01 3.19746760467E-01 3.22686347522E-01 3.25647484015E-01 3.28630160470E-01 3.31634361294E-01 3.34660064570E-01 3.37707241852E-01 3.40775857950E-01 3.43865870716E-01 3.46977230822E-01 3.50109881535E-01 3.53263758489E-01 3.56438789447E-01 3.59634894066E-01 3.62851983651E-01 3.66089960910E-01 3.69348719700E-01 3.72628144773E-01 3.75928111513E-01 3.79248485674E-01 3.82589123105E-01 3.85949869486E-01 3.89330560042E-01 3.92731019267E-01 3.96151060635E-01 3.99590486317E-01 4.03049086881E-01 4.06526641001E-01 4.10022915157E-01 4.13537663329E-01 4.17070626697E-01 4.20621533329E-01 4.24190097868E-01 4.27776021225E-01 4.31378990257E-01 4.34998677455E-01 4.38634740623E-01 4.42286822556E-01 4.45954550724E-01 4.49637536946E-01 4.53335377071E-01 4.57047650657E-01 4.60773920649E-01 4.64513733062E-01 4.68266616661E-01 4.72032082645E-01 4.75809624340E-01 4.79598716881E-01 4.83398816912E-01 4.87209362287E-01 4.91029771767E-01 4.94859444737E-01 4.98697760919E-01 5.02544080100E-01 5.06397741860E-01 5.10258065318E-01 5.14124348883E-01 5.17995870016E-01 5.21871885003E-01 5.25751628749E-01 5.29634314576E-01 5.33519134037E-01 5.37405256758E-01 5.41291830280E-01 5.45177979937E-01 5.49062808738E-01 5.52945397285E-01 5.56824803703E-01 5.60700063599E-01 5.64570190045E-01 5.68434173589E-01 5.72290982297E-01 5.76139561818E-01 5.79978835487E-01 5.83807704460E-01 5.87625047884E-01 5.91429723101E-01 5.95220565897E-01 5.98996390782E-01 6.02755991323E-01 6.06498140510E-01 6.10221591173E-01 6.13925076452E-01 6.17607310301E-01 6.21266988058E-01 6.24902787063E-01 6.28513367326E-01 6.32097372254E-01 6.35653429442E-01 6.39180151513E-01 6.42676137028E-01 6.46139971452E-01 6.49570228193E-01 6.52965469693E-01 6.56324248600E-01 6.59645108998E-01 6.62926587707E-01 6.66167215661E-01 6.69365519341E-01 6.72520022293E-01 6.75629246707E-01 6.78691715070E-01 6.81705951889E-01 6.84670485483E-01 6.87583849845E-01 6.90444586567E-01 6.93251246835E-01 6.96002393482E-01 6.98696603109E-01 7.01332468253E-01 7.03908599618E-01 7.06423628351E-01 7.08876208360E-01 7.11265018678E-01 7.13588765853E-01 7.15846186367E-01 7.18036049071E-01 7.20157157633E-01 7.22208352978E-01 7.24188515727E-01 7.26096568607E-01 7.27931478823E-01 7.29692260393E-01 7.31377976406E-01 7.32987741207E-01 7.34520722482E-01 7.35976143229E-01 7.37353283591E-01 7.38651482528E-01 7.39870139308E-01 7.41008714797E-01 7.42066732505E-01 7.43043779380E-01 7.43939506305E-01 7.44753628276E-01 7.45485924217E-01 7.46136236414E-01 7.46704469508E-01 7.47190589038E-01 7.47594619462E-01 7.47916641641E-01 7.48156789731E-01 7.48315247442E-01 7.48392243617E-01 7.48388047095E-01 7.48302960800E-01 7.48137315026E-01 7.47891459858E-01 7.47565756708E-01 7.47160568905E-01 7.46676251318E-01 7.46113138980E-01 7.45471534677E-01 7.44751695497E-01 7.43953818334E-01 7.43078024333E-01 7.42124342319E-01 7.41092691219E-01 7.39982861388E-01 7.38794494442E-01 7.37527061759E-01 7.36179841725E-01 7.34751895770E-01 7.33242043187E-01 7.31648834777E-01 7.29970812574E-01 7.28207467019E-01 7.26358576622E-01 7.24423950917E-01 7.22403431119E-01 7.20296890782E-01 7.18104236445E-01 7.15825408268E-01 7.13460380653E-01 7.11009162859E-01 7.08471799596E-01 7.05848371611E-01 7.03138996256E-01 7.00343828039E-01 6.97463059160E-01 6.94496920024E-01 6.91445679740E-01 6.88309646595E-01 6.85089168512E-01 6.81784633474E-01 6.78396469938E-01 6.74925147212E-01 6.71371175817E-01 6.67735107810E-01 6.64017537087E-01 6.60219099654E-01 6.56340473865E-01 6.52382380634E-01 6.48345583605E-01 6.44230889300E-01 6.40039147219E-01 6.35771249912E-01 6.31428133012E-01 6.27010775229E-01 6.22520198305E-01 6.17957466926E-01 6.13323688597E-01 6.08620013470E-01 6.03847634133E-01 5.99007785352E-01 5.94101743767E-01 5.89130827545E-01 5.84096129869E-01 5.78999314188E-01 5.73841820682E-01 5.68625129185E-01 5.63350758596E-01 5.58020266244E-01 5.52635247189E-01 5.47197333493E-01 5.41708193417E-01 5.36169530562E-01 5.30583082992E-01 5.24950622294E-01 5.19273952582E-01 5.13554909443E-01 5.07795358844E-01 5.01997195981E-01 4.96162344078E-01 4.90292753138E-01 4.84390398646E-01 4.78457280224E-01 4.72495420235E-01 4.66506862343E-01 4.60493670033E-01 4.54457925080E-01 4.48401725980E-01 4.42327186341E-01 4.36236433231E-01 4.30131605495E-01 4.24014852036E-01 4.17888330055E-01 4.11754203276E-01 4.05614640129E-01 3.99471811917E-01 3.93327890954E-01 3.87185048689E-01 3.81045453812E-01 3.74911270343E-01 3.68784655715E-01 3.62667758850E-01 3.56562718228E-01 3.50471659961E-01 3.44396695869E-01 3.38339921565E-01 3.32303414545E-01 3.26289232303E-01 3.20299410462E-01 3.14335960920E-01 3.08400870037E-01 3.02496096839E-01 2.96623571265E-01 2.90785192448E-01 2.84982827041E-01 2.79218307582E-01 2.73493430915E-01 2.67809956652E-01 2.62169605704E-01 2.56574058855E-01 2.51024955403E-01 2.45523891859E-01 2.40072420719E-01 2.34672049288E-01 2.29324238586E-01 2.24030402309E-01 2.18791905874E-01 2.13610065523E-01 2.08486147503E-01 2.03421367322E-01 1.98416889069E-01 1.93473824812E-01 1.88593234060E-01 1.83776123305E-01 1.79023445628E-01 1.74336100375E-01 1.69714932899E-01 1.65160734378E-01 1.60674241686E-01 1.56256137337E-01 1.51907049490E-01 1.47627552016E-01 1.43418164621E-01 1.39279353036E-01 1.35211529252E-01 1.31215051826E-01 1.27290226226E-01 1.23437305239E-01 1.19656489425E-01 1.15947927624E-01 1.12311717511E-01 1.08747906194E-01 1.05256490865E-01 1.01837419490E-01 9.84905915469E-02 9.52158588005E-02 9.20130261229E-02 8.88818523529E-02 8.58220511926E-02 8.28332921437E-02 7.99152014786E-02 7.70673632479E-02 7.42893203214E-02 7.15805754624E-02 6.89405924334E-02 6.63687971325E-02 6.38645787584E-02 6.14272910038E-02 5.90562532744E-02 5.67507519337E-02 5.45100415703E-02 5.23333462876E-02 5.02198610135E-02 4.81687528290E-02 4.61791623130E-02 4.42502049029E-02 4.23809722680E-02 4.05705336946E-02 3.88179374800E-02 3.71222123348E-02 3.54823687899E-02 3.38974006077E-02 3.23662861935E-02 3.08879900077E-02 2.94614639735E-02 2.80856488809E-02 2.67594757826E-02 2.54818673811E-02 2.42517394040E-02 2.30680019658E-02 2.19295609135E-02 2.08353191552E-02 1.97841779677E-02 1.87750382827E-02 1.78068019489E-02 1.68783729675E-02 1.59886587009E-02 1.51365710508E-02 1.43210276050E-02 1.35409527514E-02 1.27952787566E-02 1.20829468087E-02 1.14029080221E-02 1.07541244030E-02 1.01355697753E-02 9.54623066431E-03 8.98510713799E-03 8.45121360548E-03 7.94357957069E-03 7.46125034146E-03 7.00328769308E-03 6.56877048606E-03 6.15679523767E-03 5.76647664706E-03 5.39694807401E-03 5.04736197119E-03 4.71689027026E-03 4.40472472194E-03 4.11007719065E-03 3.83217990397E-03 3.57028565788E-03 3.32366797827E-03 3.09162123963E-03 2.87346074190E-03 2.66852274662E-03 2.47616447318E-03 2.29576405688E-03 2.12672046961E-03 1.96845340488E-03 1.82040312852E-03 1.68203029647E-03 1.55281574142E-03 1.43226022968E-03 1.31988419016E-03 1.21522741697E-03 1.11784874750E-03 1.02732571754E-03 9.43254195471E-04 8.65247996955E-04 7.92938482179E-04 7.25974137239E-04 6.64020141475E-04 6.06757922471E-04 5.53884700430E-04 5.05113023595E-04 4.60170296357E-04 4.18798301642E-04 3.80752719136E-04 3.45802640850E-04 3.13730085466E-04 2.84329512855E-04 2.57407340104E-04 2.32781460291E-04 2.10280765233E-04 1.89744673303E-04 1.71022663384E-04 1.53973815942E-04 1.38466362110E-04 1.24377241629E-04 1.11591670394E-04 1.00002718282E-04 8.95108978843E-05 8.00237646599E-05 7.14555289832E-05 6.37266804733E-05 5.67636249286E-05 5.04983341241E-05 4.48680086630E-05 3.98147540156E-05 3.52852698177E-05 3.12305524464E-05 2.76056108393E-05 2.43691954730E-05 2.14835403733E-05 1.89141179850E-05 1.66294066934E-05 1.46006707532E-05 1.28017523485E-05 1.12088754840E-05 9.80046137674E-06 8.55695500439E-06 7.46066244352E-06 6.49559862056E-06 5.64734508660E-06 4.90291742077E-06 4.25064186248E-06 3.68004077266E-06 3.18172652625E-06 2.74730344403E-06 2.36927738012E-06 2.04097259455E-06 1.75645555483E-06 1.51046532977E-06 1.29835026241E-06 1.11601063618E-06 9.57700997876E-07 8.20483635870E-07 7.01748447427E-07 5.99180492189E-07 5.10730262545E-07 4.34586500954E-07 3.69151394966E-07 3.13017991729E-07 2.64949674896E-07 2.23861554948E-07 1.88803629998E-07 1.58945580791E-07 1.33563070386E-07 1.12025425883E-07 9.37845864333E-08 7.83652086713E-08 6.53558274395E-08 5.44009763835E-08 4.51941794799E-08 3.74717308793E-08 3.10071865455E-08 2.56064970346E-08 2.11037163591E-08 1.73572272182E-08 1.42464279334E-08 1.16688312014E-08 9.53752926020E-09 7.77898427073E-09 6.33110662861E-09 5.14158756672E-09 4.16645577736E-09 3.36883089364E-09 2.71784952841E-09 2.18774218733E-09 1.75704176368E-09 1.40790649746E-09 1.12554225357E-09 8.97710756706E-10 7.14312026037E-10 5.67030694938E-10 4.49037191230E-10 3.54735904716E-10 2.79553492516E-10 2.19761380198E-10 1.72327318590E-10 1.34791562461E-10 1.05163857481E-10 8.18379646891E-11 6.35209253527E-11 4.91746811030E-11 3.79680213958E-11 2.92371391205E-11 2.24533411707E-11 1.71966892702E-11 1.31345419511E-11 1.00041355261E-11 7.59848392258E-12 5.75499768671E-12 4.34632427822E-12 3.27299756527E-12 2.45755648143E-12 1.83985312912E-12 1.37332094992E-12 1.02201544978E-12 7.58274675482E-13 5.60875318152E-13 4.13583938694E-13 3.04022196502E-13 2.22780822519E-13 1.62730008008E-13 1.18484386943E-13 8.59892978921E-14 6.22018770851E-14 4.48460559955E-14 3.22249618458E-14 2.30777533624E-14 1.64707363878E-14 1.17148340022E-14 8.30324785374E-15 5.86453463051E-15 4.12740980702E-15 2.89444129528E-15 2.02245790356E-15 1.40801129617E-15 9.76627253805E-16 6.74887798617E-16 4.64620286471E-16 3.18648783834E-16 2.17699458662E-16 1.48155142518E-16 1.00432332321E-16 6.78126579722E-17 4.56048652411E-17 3.05462139620E-17 2.03766055898E-17 1.35365326668E-17 8.95522115822E-18 5.89956946205E-18 3.87009033647E-18 2.52790145157E-18 1.64406398503E-18 1.06457908714E-18 6.86307416714E-19 4.40475459763E-19 2.81428145947E-19 1.78993168333E-19 1.13320537281E-19 7.14108114140E-20 4.47901185917E-20 2.79603679947E-20 1.73710191289E-20 1.07401060547E-20 6.60802379315E-21 4.04569437846E-21 2.46462850232E-21 1.49391208429E-21 9.00931627324E-22 5.40542274216E-22 3.22638456106E-22 1.91570487043E-22 1.13147308112E-22 6.64721786615E-23 3.88411738858E-23 2.25724123477E-23 1.30458688807E-23 7.49813786209E-24 4.28543529014E-24 2.43541545400E-24 1.37614123790E-24 7.73107325605E-25 4.31795523358E-25 2.39746644098E-25 1.32323573982E-25 7.25949087218E-26 3.95852206094E-26 2.14531656432E-26 1.15545833890E-26 6.18435902560E-27 3.28916175124E-27 1.73819407254E-27 9.12653403684E-28 4.76079931062E-28 2.46712852294E-28 1.27002658313E-28 6.49402461234E-29 3.29811491691E-29 1.66356099745E-29 8.33302774568E-30 4.14503151925E-30 2.04730813999E-30 1.00401015052E-30 4.88833934295E-31 2.36277010336E-31 1.13367005073E-31 5.39914331360E-32 2.55213462041E-32 1.19726444199E-32 5.57379874254E-33 2.57486079136E-33 1.18022209202E-33 5.36719215114E-34 2.42141666523E-34 1.08366763912E-34 4.81051686123E-35 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 8.24047802328E-06 8.40694415255E-06 8.57677301585E-06 8.75003254063E-06 8.92679202640E-06 9.10712217242E-06 9.29109510600E-06 9.47878441130E-06 9.67026515878E-06 9.86561393521E-06 1.00649088743E-05 1.02682296880E-05 1.04756576981E-05 1.06872758691E-05 1.09031688414E-05 1.11234229646E-05 1.13481263328E-05 1.15773688190E-05 1.18112421117E-05 1.20498397515E-05 1.22932571678E-05 1.25415917180E-05 1.27949427255E-05 1.30534115200E-05 1.33171014777E-05 1.35861180628E-05 1.38605688695E-05 1.41405636654E-05 1.44262144346E-05 1.47176354234E-05 1.50149431854E-05 1.53182566281E-05 1.56276970607E-05 1.59433882423E-05 1.62654564318E-05 1.65940304378E-05 1.69292416705E-05 1.72712241941E-05 1.76201147804E-05 1.79760529634E-05 1.83391810954E-05 1.87096444032E-05 1.90875910470E-05 1.94731721790E-05 1.98665420039E-05 2.02678578410E-05 2.06772801862E-05 2.10949727772E-05 2.15211026581E-05 2.19558402465E-05 2.23993594016E-05 2.28518374936E-05 2.33134554747E-05 2.37843979513E-05 2.42648532577E-05 2.47550135316E-05 2.52550747908E-05 2.57652370113E-05 2.62857042075E-05 2.68166845134E-05 2.73583902661E-05 2.79110380906E-05 2.84748489859E-05 2.90500484140E-05 2.96368663894E-05 3.02355375711E-05 3.08463013567E-05 3.14694019777E-05 3.21050885970E-05 3.27536154087E-05 3.34152417395E-05 3.40902321523E-05 3.47788565519E-05 3.54813902926E-05 3.61981142887E-05 3.69293151261E-05 3.76752851769E-05 3.84363227167E-05 3.92127320429E-05 4.00048235967E-05 4.08129140871E-05 4.16373266172E-05 4.24783908132E-05 4.33364429560E-05 4.42118261158E-05 4.51048902887E-05 4.60159925363E-05 4.69454971290E-05 4.78937756904E-05 4.88612073466E-05 4.98481788768E-05 5.08550848681E-05 5.18823278730E-05 5.29303185697E-05 5.39994759266E-05 5.50902273689E-05 5.62030089495E-05 5.73382655231E-05 5.84964509234E-05 5.96780281443E-05 6.08834695250E-05 6.21132569377E-05 6.33678819805E-05 6.46478461733E-05 6.59536611579E-05 6.72858489017E-05 6.86449419067E-05 7.00314834210E-05 7.14460276561E-05 7.28891400075E-05 7.43613972805E-05 7.58633879200E-05 7.73957122450E-05 7.89589826883E-05 8.05538240402E-05 8.21808736982E-05 8.38407819202E-05 8.55342120845E-05 8.72618409538E-05 8.90243589448E-05 9.08224704037E-05 9.26568938863E-05 9.45283624450E-05 9.64376239202E-05 9.83854412386E-05 1.00372592717E-04 1.02399872372E-04 1.04468090237E-04 1.06578072684E-04 1.08730662752E-04 1.10926720486E-04 1.13167123274E-04 1.15452766202E-04 1.17784562405E-04 1.20163443435E-04 1.22590359629E-04 1.25066280487E-04 1.27592195060E-04 1.30169112341E-04 1.32798061667E-04 1.35480093131E-04 1.38216277994E-04 1.41007709117E-04 1.43855501393E-04 1.46760792188E-04 1.49724741798E-04 1.52748533905E-04 1.55833376051E-04 1.58980500116E-04 1.62191162810E-04 1.65466646167E-04 1.68808258060E-04 1.72217332717E-04 1.75695231251E-04 1.79243342202E-04 1.82863082086E-04 1.86555895960E-04 1.90323257992E-04 1.94166672049E-04 1.98087672291E-04 2.02087823781E-04 2.06168723107E-04 2.10331999010E-04 2.14579313036E-04 2.18912360191E-04 2.23332869612E-04 2.27842605253E-04 2.32443366586E-04 2.37136989310E-04 2.41925346080E-04 2.46810347248E-04 2.51793941619E-04 2.56878117220E-04 2.62064902091E-04 2.67356365084E-04 2.72754616682E-04 2.78261809832E-04 2.83880140798E-04 2.89611850028E-04 2.95459223037E-04 3.01424591315E-04 3.07510333242E-04 3.13718875030E-04 3.20052691679E-04 3.26514307953E-04 3.33106299380E-04 3.39831293261E-04 3.46691969712E-04 3.53691062714E-04 3.60831361197E-04 3.68115710131E-04 3.75547011652E-04 3.83128226201E-04 3.90862373689E-04 3.98752534689E-04 4.06801851638E-04 4.15013530083E-04 4.23390839932E-04 4.31937116742E-04 4.40655763030E-04 4.49550249604E-04 4.58624116928E-04 4.67880976510E-04 4.77324512316E-04 4.86958482215E-04 4.96786719450E-04 5.06813134140E-04 5.17041714809E-04 5.27476529945E-04 5.38121729594E-04 5.48981546977E-04 5.60060300149E-04 5.71362393680E-04 5.82892320376E-04 5.94654663031E-04 6.06654096213E-04 6.18895388087E-04 6.31383402269E-04 6.44123099719E-04 6.57119540673E-04 6.70377886610E-04 6.83903402252E-04 6.97701457617E-04 7.11777530094E-04 7.26137206573E-04 7.40786185607E-04 7.55730279622E-04 7.70975417161E-04 7.86527645186E-04 8.02393131406E-04 8.18578166664E-04 8.35089167364E-04 8.51932677947E-04 8.69115373410E-04 8.86644061879E-04 9.04525687227E-04 9.22767331746E-04 9.41376218864E-04 9.60359715921E-04 9.79725336993E-04 9.99480745771E-04 1.01963375849E-03 1.04019234694E-03 1.06116464148E-03 1.08255893416E-03 1.10438368188E-03 1.12664750963E-03 1.14935921373E-03 1.17252776522E-03 1.19616231325E-03 1.22027218853E-03 1.24486690691E-03 1.26995617294E-03 1.29554988358E-03 1.32165813189E-03 1.34829121089E-03 1.37545961740E-03 1.40317405599E-03 1.43144544305E-03 1.46028491083E-03 1.48970381162E-03 1.51971372206E-03 1.55032644739E-03 1.58155402590E-03 1.61340873341E-03 1.64590308783E-03 1.67904985382E-03 1.71286204753E-03 1.74735294141E-03 1.78253606912E-03 1.81842523055E-03 1.85503449687E-03 1.89237821574E-03 1.93047101656E-03 1.96932781584E-03 2.00896382268E-03 2.04939454427E-03 2.09063579162E-03 2.13270368524E-03 2.17561466105E-03 2.21938547630E-03 2.26403321565E-03 2.30957529733E-03 2.35602947939E-03 2.40341386612E-03 2.45174691450E-03 2.50104744083E-03 2.55133462742E-03 2.60262802942E-03 2.65494758175E-03 2.70831360620E-03 2.76274681855E-03 2.81826833588E-03 2.87489968401E-03 2.93266280501E-03 2.99158006485E-03 3.05167426122E-03 3.11296863142E-03 3.17548686039E-03 3.23925308890E-03 3.30429192182E-03 3.37062843656E-03 3.43828819163E-03 3.50729723535E-03 3.57768211464E-03 3.64946988403E-03 3.72268811470E-03 3.79736490381E-03 3.87352888379E-03 3.95120923188E-03 4.03043567985E-03 4.11123852371E-03 4.19364863370E-03 4.27769746439E-03 4.36341706487E-03 4.45084008916E-03 4.53999980668E-03 4.63093011298E-03 4.72366554049E-03 4.81824126950E-03 4.91469313926E-03 5.01305765921E-03 5.11337202039E-03 5.21567410697E-03 5.32000250793E-03 5.42639652888E-03 5.53489620405E-03 5.64554230835E-03 5.75837636971E-03 5.87344068141E-03 5.99077831462E-03 6.11043313113E-03 6.23244979608E-03 6.35687379098E-03 6.48375142675E-03 6.61312985694E-03 6.74505709108E-03 6.87958200812E-03 7.01675437004E-03 7.15662483557E-03 7.29924497398E-03 7.44466727903E-03 7.59294518303E-03 7.74413307097E-03 7.89828629479E-03 8.05546118771E-03 8.21571507864E-03 8.37910630676E-03 8.54569423604E-03 8.71553926996E-03 8.88870286622E-03 9.06524755150E-03 9.24523693635E-03 9.42873573001E-03 9.61580975535E-03 9.80652596379E-03 1.00009524503E-02 1.01991584681E-02 1.04012144440E-02 1.06071919931E-02 1.08171639335E-02 1.10312043014E-02 1.12493883660E-02 1.14717926437E-02 1.16984949132E-02 1.19295742299E-02 1.21651109403E-02 1.24051866960E-02 1.26498844683E-02 1.28992885619E-02 1.31534846285E-02 1.34125596805E-02 1.36766021044E-02 1.39457016738E-02 1.42199495618E-02 1.44994383542E-02 1.47842620609E-02 1.50745161281E-02 1.53702974497E-02 1.56717043781E-02 1.59788367347E-02 1.62917958203E-02 1.66106844243E-02 1.69356068341E-02 1.72666688430E-02 1.76039777586E-02 1.79476424097E-02 1.82977731527E-02 1.86544818775E-02 1.90178820127E-02 1.93880885294E-02 1.97652179444E-02 2.01493883234E-02 2.05407192813E-02 2.09393319835E-02 2.13453491449E-02 2.17588950282E-02 2.21800954410E-02 2.26090777315E-02 2.30459707831E-02 2.34909050078E-02 2.39440123377E-02 2.44054262151E-02 2.48752815820E-02 2.53537148662E-02 2.58408639675E-02 2.63368682410E-02 2.68418684788E-02 2.73560068903E-02 2.78794270794E-02 2.84122740211E-02 2.89546940343E-02 2.95068347536E-02 3.00688450983E-02 3.06408752388E-02 3.12230765608E-02 3.18156016264E-02 3.24186041331E-02 3.30322388693E-02 3.36566616676E-02 3.42920293542E-02 3.49384996962E-02 3.55962313446E-02 3.62653837744E-02 3.69461172218E-02 3.76385926167E-02 3.83429715124E-02 3.90594160109E-02 3.97880886850E-02 4.05291524953E-02 4.12827707041E-02 4.20491067840E-02 4.28283243233E-02 4.36205869257E-02 4.44260581058E-02 4.52449011803E-02 4.60772791534E-02 4.69233545977E-02 4.77832895302E-02 4.86572452826E-02 4.95453823661E-02 5.04478603313E-02 5.13648376221E-02 5.22964714239E-02 5.32429175058E-02 5.42043300576E-02 5.51808615197E-02 5.61726624078E-02 5.71798811308E-02 5.82026638025E-02 5.92411540472E-02 6.02954927986E-02 6.13658180919E-02 6.24522648497E-02 6.35549646613E-02 6.46740455550E-02 6.58096317639E-02 6.69618434848E-02 6.81307966304E-02 6.93166025748E-02 7.05193678926E-02 7.17391940906E-02 7.29761773332E-02 7.42304081616E-02 7.55019712057E-02 7.67909448907E-02 7.80974011360E-02 7.94214050494E-02 8.07630146141E-02 8.21222803709E-02 8.34992450944E-02 8.48939434635E-02 8.63064017274E-02 8.77366373665E-02 8.91846587490E-02 9.06504647831E-02 9.21340445659E-02 9.36353770283E-02 9.51544305775E-02 9.66911627374E-02 9.82455197858E-02 9.98174363922E-02 1.01406835253E-01 1.03013626727E-01 1.04637708474E-01 1.06278965090E-01 1.07937267746E-01 1.09612473835E-01 1.11304426614E-01 1.13012954856E-01 1.14737872505E-01 1.16478978341E-01 1.18236055645E-01 1.20008871885E-01 1.21797178395E-01 1.23600710078E-01 1.25419185117E-01 1.27252304696E-01 1.29099752739E-01 1.30961195661E-01 1.32836282140E-01 1.34724642906E-01 1.36625890546E-01 1.38539619333E-01 1.40465405078E-01 1.42402805008E-01 1.44351357660E-01 1.46310582812E-01 1.48279981438E-01 1.50259035690E-01 1.52247208919E-01 1.54243945717E-01 1.56248672006E-01 1.58260795151E-01 1.60279704115E-01 1.62304769654E-01 1.64335344547E-01 1.66370763867E-01 1.68410345295E-01 1.70453389478E-01 1.72499180425E-01 1.74546985954E-01 1.76596058178E-01 1.78645634041E-01 1.80694935897E-01 1.82743172137E-01 1.84789537858E-01 1.86833215589E-01 1.88873376048E-01 1.90909178955E-01 1.92939773890E-01 1.94964301184E-01 1.96981892868E-01 1.98991673651E-01 2.00992761942E-01 2.02984270911E-01 2.04965309584E-01 2.06934983968E-01 2.08892398210E-01 2.10836655781E-01 2.12766860685E-01 2.14682118682E-01 2.16581538535E-01 2.18464233262E-01 2.20329321393E-01 2.22175928239E-01 2.24003187141E-01 2.25810240725E-01 2.27596242130E-01 2.29360356225E-01 2.31101760790E-01 2.32819647666E-01 2.34513223864E-01 2.36181712633E-01 2.37824354456E-01 2.39440408006E-01 2.41029151020E-01 2.42589881097E-01 2.44121916422E-01 2.45624596392E-01 2.47097282152E-01 2.48539357022E-01 2.49950226824E-01 2.51329320084E-01 2.52676088121E-01 2.53990005010E-01 2.55270567414E-01 2.56517294282E-01 2.57729726414E-01 2.58907425883E-01 2.60049975321E-01 2.61156977062E-01 2.62228052146E-01 2.63262839180E-01 2.64260993069E-01 2.65222183605E-01 2.66146093937E-01 2.67032418910E-01 2.67880863291E-01 2.68691139887E-01 2.69462967561E-01 2.70196069164E-01 2.70890169384E-01 2.71544992533E-01 2.72160260276E-01 2.72735689325E-01 2.73270989105E-01 2.73765859414E-01 2.74219988075E-01 2.74633048618E-01 2.75004697985E-01 2.75334574287E-01 2.75622294608E-01 2.75867452884E-01 2.76069617856E-01 2.76228331103E-01 2.76343105160E-01 2.76413421726E-01 2.76438729950E-01 2.76418444794E-01 2.76351945454E-01 2.76238573829E-01 2.76077633012E-01 2.75868385766E-01 2.75610052964E-01 2.75301811936E-01 2.74942794684E-01 2.74532085903E-01 2.74068720755E-01 2.73551682307E-01 2.72979898581E-01 2.72352426195E-01 2.71669041588E-01 2.70929737508E-01 2.70134544453E-01 2.69283530793E-01 2.68376802763E-01 2.67414504318E-01 2.66396816852E-01 2.65323965846E-01 2.64196244559E-01 2.63013997704E-01 2.61777615408E-01 2.60487533528E-01 2.59144233914E-01 2.57748244614E-01 2.56300140020E-01 2.54800540956E-01 2.53250114706E-01 2.51649574971E-01 2.49999681771E-01 2.48301241276E-01 2.46555105565E-01 2.44762172326E-01 2.42923384478E-01 2.41039729725E-01 2.39112240041E-01 2.37141991072E-01 2.35130101482E-01 2.33077732207E-01 2.30986085645E-01 2.28856404775E-01 2.26689972189E-01 2.24488109061E-01 2.22252174039E-01 2.19983562059E-01 2.17683703096E-01 2.15354060828E-01 2.12996131244E-01 2.10611441174E-01 2.08201546751E-01 2.05768031809E-01 2.03312506209E-01 2.00836604113E-01 1.98341982187E-01 1.95830317744E-01 1.93303306846E-01 1.90762662329E-01 1.88210111799E-01 1.85647395567E-01 1.83076264544E-01 1.80498325954E-01 1.77915498733E-01 1.75329552660E-01 1.72742259323E-01 1.70155389845E-01 1.67570712593E-01 1.64989990869E-01 1.62414980585E-01 1.59847427936E-01 1.57289067056E-01 1.54741617699E-01 1.52206782916E-01 1.49686246746E-01 1.47181671922E-01 1.44694697598E-01 1.42226937105E-01 1.39779975733E-01 1.37355368564E-01 1.34954638329E-01 1.32579273328E-01 1.30230725390E-01 1.27910407900E-01 1.25619693879E-01 1.23359914136E-01 1.21132355486E-01 1.18938259047E-01 1.16778818614E-01 1.14655179114E-01 1.12568435152E-01 1.10519629639E-01 1.08509752525E-01 1.06539739616E-01 1.04610471496E-01 1.02722772550E-01 1.00877410090E-01 9.90750935810E-02 9.73164739807E-02 9.56021431815E-02 9.39326335622E-02 9.23084176480E-02 9.07299078790E-02 8.91974564870E-02 8.77113554800E-02 8.62718367328E-02 8.48790721837E-02 8.35331741342E-02 8.22341956504E-02 8.09821310641E-02 7.97769165704E-02 7.86184309192E-02 7.75064961977E-02 7.64408786998E-02 7.54212898796E-02 7.44473873847E-02 7.35187761655E-02 7.26350096561E-02 7.17955910227E-02 7.09999744750E-02 7.02475666362E-02 6.95377279669E-02 6.88697742383E-02 6.82429780505E-02 6.76565703907E-02 6.71097422275E-02 6.66016461359E-02 6.61313979497E-02 6.56980784367E-02 6.53007349913E-02 6.49383833432E-02 6.46100092755E-02 6.43145703508E-02 6.40509976404E-02 6.38181974544E-02 6.36150530684E-02 6.34404264458E-02 6.32931599509E-02 6.31720780528E-02 6.30759890157E-02 6.30036865752E-02 6.29539515982E-02 6.29255537252E-02 6.29172529935E-02 6.29278014402E-02 6.29559446843E-02 6.30004234875E-02 6.30599752917E-02 6.31333357353E-02 6.32192401459E-02 6.33164250102E-02 6.34236294216E-02 6.35395965051E-02 6.36630748199E-02 6.37928197403E-02 6.39275948158E-02 6.40661731097E-02 6.42073385181E-02 6.43498870699E-02 6.44926282071E-02 6.46343860484E-02 6.47740006339E-02 6.49103291551E-02 6.50422471675E-02 6.51686497882E-02 6.52884528796E-02 6.54005942174E-02 6.55040346460E-02 6.55977592199E-02 6.56807783309E-02 6.57521288237E-02 6.58108750961E-02 6.58561101874E-02 6.58869568511E-02 6.59025686147E-02 6.59021308225E-02 6.58848616636E-02 6.58500131819E-02 6.57968722673E-02 6.57247616270E-02 6.56330407353E-02 6.55211067584E-02 6.53883954550E-02 6.52343820469E-02 6.50585820595E-02 6.48605521295E-02 6.46398907743E-02 6.43962391234E-02 6.41292816060E-02 6.38387465923E-02 6.35244069849E-02 6.31860807569E-02 6.28236314312E-02 6.24369684996E-02 6.20260477758E-02 6.15908716787E-02 6.11314894423E-02 6.06479972478E-02 6.01405382741E-02 5.96093026627E-02 5.90545273927E-02 5.84764960632E-02 5.78755385786E-02 5.72520307338E-02 5.66063936964E-02 5.59390933829E-02 5.52506397263E-02 5.45415858334E-02 5.38125270293E-02 5.30640997887E-02 5.22969805520E-02 5.15118844267E-02 5.07095637741E-02 4.98908066811E-02 4.90564353198E-02 4.82073041953E-02 4.73442982845E-02 4.64683310698E-02 4.55803424701E-02 4.46812966745E-02 4.37721798826E-02 4.28539979583E-02 4.19277740021E-02 4.09945458493E-02 4.00553635022E-02 3.91112865035E-02 3.81633812591E-02 3.72127183215E-02 3.62603696413E-02 3.53074057974E-02 3.43548932176E-02 3.34038913992E-02 3.24554501548E-02 3.15106068234E-02 3.05703836035E-02 2.96357848725E-02 2.87077945788E-02 2.77873737019E-02 2.68754577939E-02 2.59729546105E-02 2.50807418454E-02 2.41996649762E-02 2.33305352332E-02 2.24741276991E-02 2.16311795499E-02 2.08023884442E-02 1.99884110679E-02 1.91898618415E-02 1.84073117956E-02 1.76412876186E-02 1.68922708814E-02 1.61606974405E-02 1.54469570223E-02 1.47513929891E-02 1.40743022857E-02 1.34159355660E-02 1.27764974959E-02 1.21561472306E-02 1.15549990602E-02 1.09731232186E-02 1.04105468494E-02 9.86725512078E-03 9.34319248221E-03 8.83826405275E-03 8.35233713217E-03 7.88524282419E-03 7.43677776128E-03 7.00670591954E-03 6.59476051232E-03 6.20064595052E-03 5.82403985773E-03 5.46459512805E-03 5.12194201456E-03 4.79569023662E-03 4.48543109411E-03 4.19073957733E-03 3.91117646154E-03 3.64629037533E-03 3.39561983307E-03 3.15869522166E-03 2.93504073290E-03 2.72417623324E-03 2.52561906352E-03 2.33888576199E-03 2.16349370474E-03 1.99896265849E-03 1.84481624134E-03 1.70058328829E-03 1.56579911832E-03 1.44000670182E-03 1.32275772694E-03 1.21361356441E-03 1.11214613132E-03 1.01793865484E-03 9.30586337453E-04 8.49696925997E-04 7.74891187156E-04 7.05803292747E-04 6.42081118455E-04 5.83386459456E-04 5.29395168268E-04 4.79797218690E-04 4.34296700778E-04 3.92611751793E-04 3.54474428161E-04 3.19630523542E-04 2.87839338074E-04 2.58873403889E-04 2.32518171845E-04 2.08571664382E-04 1.86844099206E-04 1.67157488382E-04 1.49345217197E-04 1.33251606930E-04 1.18731465475E-04 1.05649629465E-04 9.38805013251E-05 8.33075844105E-05 7.38230191119E-05 6.53271225557E-05 5.77279342542E-05 5.09407698032E-05 4.48877844698E-05 3.94975482687E-05 3.47046338888E-05 3.04492186069E-05 2.66767011158E-05 2.33373339903E-05 2.03858723359E-05 1.77812389884E-05 1.54862064790E-05 1.34670958378E-05 1.16934921790E-05 1.01379768992E-05 8.77587621940E-06 7.58502571502E-06 6.54555040316E-06 5.63965989527E-06 4.85145807090E-06 4.16676668835E-06 3.57296231648E-06 3.05882594958E-06 2.61440465303E-06 2.23088458011E-06 1.90047469954E-06 1.61630057855E-06 1.37230757539E-06 1.16317280996E-06 9.84225298108E-07 8.31373656035E-07 7.01040804000E-07 5.90105123089E-07 4.95847545052E-07 4.15904082115E-07 3.48223331280E-07 2.91028515377E-07 2.42783650860E-07 2.02163459671E-07 1.68026669315E-07 1.39392371348E-07 1.15419133660E-07 9.53865860916E-08 7.86792220126E-08 6.47721803730E-08 5.32187934531E-08 4.36397049842E-08 3.57133815395E-08 2.91678570735E-08 2.37735662565E-08 1.93371368328E-08 1.56960246642E-08 1.27138874501E-08 1.02766043952E-08 8.28885937544E-09 6.67121448921E-09 5.35760933844E-09 4.29322901179E-09 3.43269060672E-09 2.73850428179E-09 2.17977033248E-09 1.73107868721E-09 1.37158157693E-09 1.08421399080E-09 8.55039938794E-10 6.72705543380E-10 5.27982617302E-10 4.13388691149E-10 3.22871467566E-10 2.51548178950E-10 1.95494366390E-10 1.51551180498E-10 1.17188599453E-10 9.03860095504E-11 6.95337425879E-11 5.33527934043E-11 4.08295311970E-11 3.11627439241E-11 2.37208000784E-11 1.80070877615E-11 1.36322071698E-11 1.02916579900E-11 7.74798529396E-12 5.81653285338E-12 4.35410699107E-12 3.24998199248E-12 2.41878389370E-12 1.79487669299E-12 1.32794674379E-12 9.79539858748E-13 7.20353672385E-13 5.28126920251E-13 3.85999047743E-13 2.81239263357E-13 2.04264887056E-13 1.47885520045E-13 1.06722929280E-13 7.67672196939E-14 5.50383717191E-14 3.93289714900E-14 2.80093003283E-14 1.98801591510E-14 1.40621102194E-14 9.91240761694E-15 6.96290775837E-15 4.87382165018E-15 3.39938724101E-15 2.36247936036E-15 1.63589710852E-15 1.12862215253E-15 7.75764076992E-16 5.31230489602E-16 3.62403276987E-16 2.46286400322E-16 1.66729009471E-16 1.12431342652E-16 7.55182657783E-17 5.05228370649E-17 3.36648837375E-17 2.23409975629E-17 1.47654359233E-17 9.71830006774E-18 6.36966425416E-18 4.15725548941E-18 2.70173294545E-18 1.74825639734E-18 1.12635745077E-18 7.22498810188E-19 4.61391202787E-19 2.93328670143E-19 1.85641499682E-19 1.16953801046E-19 7.33428095522E-20 4.57818200313E-20 2.84455703513E-20 1.75924044877E-20 1.08303623087E-20 6.63761784173E-21 4.05061714221E-21 2.46225261836E-21 1.49188663813E-21 9.02059289482E-22 5.45378902171E-22 TDDFPT/Examples/pseudo/C.pbe-mt_gipaw.UPF0000644000175000017500000144025612341371476016334 0ustar mbamba Generated using "atomic" code by A. Dal Corso (espresso distribution) Author: Matteo Calandra Generation date: 3Apr2008 C 1 The Pseudo was generated with a Scalar-Relativistic Calculation 1 1.5000000E+00 L component and cutoff radius for Local Potential nl pn l occ Rcut Rcut US E pseu 2S 1 0 2.00 1.50000000000 1.50000000000 -1.42411877197 2P 2 1 1.50 1.50000000000 1.50000000000 -0.78795211864 0 Version Number C Element NC Norm - Conserving pseudopotential F Nonlinear Core Correction SLA PW PBX PBC PBE Exchange-Correlation functional 4.00000000000 Z valence -10.44139757378 Total energy 0.000 0.000 Suggested cutoff for wfc and rho 1 Max angular momentum component 1073 Number of points in mesh 4 1 Number of Wavefunctions, Number of Projectors Wavefunctions nl l occ 2S 0 2.00 3S 0 0.00 2P 1 1.50 3P 1 0.00 1.51980327592E-04 1.53892004778E-04 1.55827727903E-04 1.57787799427E-04 1.59772525616E-04 1.61782216587E-04 1.63817186358E-04 1.65877752898E-04 1.67964238175E-04 1.70076968205E-04 1.72216273108E-04 1.74382487154E-04 1.76575948818E-04 1.78797000833E-04 1.81045990244E-04 1.83323268459E-04 1.85629191307E-04 1.87964119095E-04 1.90328416658E-04 1.92722453424E-04 1.95146603465E-04 1.97601245560E-04 2.00086763252E-04 2.02603544907E-04 2.05151983779E-04 2.07732478065E-04 2.10345430974E-04 2.12991250784E-04 2.15670350911E-04 2.18383149969E-04 2.21130071838E-04 2.23911545731E-04 2.26728006258E-04 2.29579893498E-04 2.32467653063E-04 2.35391736171E-04 2.38352599718E-04 2.41350706343E-04 2.44386524507E-04 2.47460528563E-04 2.50573198830E-04 2.53725021668E-04 2.56916489558E-04 2.60148101172E-04 2.63420361456E-04 2.66733781707E-04 2.70088879655E-04 2.73486179539E-04 2.76926212196E-04 2.80409515136E-04 2.83936632634E-04 2.87508115808E-04 2.91124522710E-04 2.94786418411E-04 2.98494375090E-04 3.02248972122E-04 3.06050796171E-04 3.09900441280E-04 3.13798508963E-04 3.17745608302E-04 3.21742356038E-04 3.25789376672E-04 3.29887302559E-04 3.34036774008E-04 3.38238439383E-04 3.42492955202E-04 3.46800986242E-04 3.51163205641E-04 3.55580295006E-04 3.60052944516E-04 3.64581853030E-04 3.69167728201E-04 3.73811286581E-04 3.78513253735E-04 3.83274364354E-04 3.88095362373E-04 3.92977001082E-04 3.97920043246E-04 4.02925261227E-04 4.07993437100E-04 4.13125362778E-04 4.18321840134E-04 4.23583681128E-04 4.28911707935E-04 4.34306753068E-04 4.39769659515E-04 4.45301280867E-04 4.50902481449E-04 4.56574136461E-04 4.62317132112E-04 4.68132365754E-04 4.74020746031E-04 4.79983193015E-04 4.86020638348E-04 4.92134025396E-04 4.98324309386E-04 5.04592457563E-04 5.10939449338E-04 5.17366276442E-04 5.23873943079E-04 5.30463466085E-04 5.37135875087E-04 5.43892212663E-04 5.50733534503E-04 5.57660909579E-04 5.64675420306E-04 5.71778162716E-04 5.78970246628E-04 5.86252795819E-04 5.93626948201E-04 6.01093856003E-04 6.08654685942E-04 6.16310619414E-04 6.24062852674E-04 6.31912597025E-04 6.39861079004E-04 6.47909540579E-04 6.56059239338E-04 6.64311448688E-04 6.72667458053E-04 6.81128573077E-04 6.89696115827E-04 6.98371424997E-04 7.07155856124E-04 7.16050781792E-04 7.25057591851E-04 7.34177693635E-04 7.43412512176E-04 7.52763490435E-04 7.62232089521E-04 7.71819788922E-04 7.81528086735E-04 7.91358499902E-04 8.01312564444E-04 8.11391835705E-04 8.21597888591E-04 8.31932317818E-04 8.42396738163E-04 8.52992784712E-04 8.63722113119E-04 8.74586399864E-04 8.85587342512E-04 8.96726659985E-04 9.08006092823E-04 9.19427403460E-04 9.30992376500E-04 9.42702818992E-04 9.54560560718E-04 9.66567454474E-04 9.78725376361E-04 9.91036226079E-04 1.00350192722E-03 1.01612442759E-03 1.02890569946E-03 1.04184773994E-03 1.05495257125E-03 1.06822224104E-03 1.08165882274E-03 1.09526441582E-03 1.10904114620E-03 1.12299116651E-03 1.13711665648E-03 1.15141982324E-03 1.16590290169E-03 1.18056815484E-03 1.19541787417E-03 1.21045437997E-03 1.22568002173E-03 1.24109717849E-03 1.25670825920E-03 1.27251570314E-03 1.28852198025E-03 1.30472959154E-03 1.32114106948E-03 1.33775897840E-03 1.35458591488E-03 1.37162450817E-03 1.38887742058E-03 1.40634734791E-03 1.42403701987E-03 1.44194920052E-03 1.46008668866E-03 1.47845231832E-03 1.49704895916E-03 1.51587951695E-03 1.53494693399E-03 1.55425418962E-03 1.57380430063E-03 1.59360032176E-03 1.61364534618E-03 1.63394250597E-03 1.65449497260E-03 1.67530595744E-03 1.69637871224E-03 1.71771652967E-03 1.73932274380E-03 1.76120073064E-03 1.78335390869E-03 1.80578573941E-03 1.82849972782E-03 1.85149942304E-03 1.87478841881E-03 1.89837035409E-03 1.92224891359E-03 1.94642782840E-03 1.97091087652E-03 1.99570188347E-03 2.02080472290E-03 2.04622331718E-03 2.07196163801E-03 2.09802370707E-03 2.12441359660E-03 2.15113543008E-03 2.17819338284E-03 2.20559168276E-03 2.23333461086E-03 2.26142650203E-03 2.28987174570E-03 2.31867478649E-03 2.34784012493E-03 2.37737231817E-03 2.40727598066E-03 2.43755578493E-03 2.46821646225E-03 2.49926280341E-03 2.53069965947E-03 2.56253194250E-03 2.59476462636E-03 2.62740274748E-03 2.66045140561E-03 2.69391576469E-03 2.72780105360E-03 2.76211256696E-03 2.79685566603E-03 2.83203577949E-03 2.86765840431E-03 2.90372910658E-03 2.94025352244E-03 2.97723735889E-03 3.01468639473E-03 3.05260648146E-03 3.09100354416E-03 3.12988358245E-03 3.16925267142E-03 3.20911696256E-03 3.24948268477E-03 3.29035614525E-03 3.33174373057E-03 3.37365190763E-03 3.41608722467E-03 3.45905631228E-03 3.50256588448E-03 3.54662273973E-03 3.59123376199E-03 3.63640592184E-03 3.68214627751E-03 3.72846197603E-03 3.77536025431E-03 3.82284844032E-03 3.87093395418E-03 3.91962430933E-03 3.96892711377E-03 4.01885007114E-03 4.06940098201E-03 4.12058774506E-03 4.17241835833E-03 4.22490092045E-03 4.27804363195E-03 4.33185479646E-03 4.38634282210E-03 4.44151622273E-03 4.49738361930E-03 4.55395374122E-03 4.61123542767E-03 4.66923762904E-03 4.72796940829E-03 4.78743994237E-03 4.84765852369E-03 4.90863456152E-03 4.97037758348E-03 5.03289723705E-03 5.09620329106E-03 5.16030563720E-03 5.22521429159E-03 5.29093939634E-03 5.35749122115E-03 5.42488016485E-03 5.49311675712E-03 5.56221166005E-03 5.63217566988E-03 5.70301971861E-03 5.77475487578E-03 5.84739235014E-03 5.92094349146E-03 5.99541979224E-03 6.07083288956E-03 6.14719456687E-03 6.22451675584E-03 6.30281153822E-03 6.38209114772E-03 6.46236797195E-03 6.54365455433E-03 6.62596359604E-03 6.70930795804E-03 6.79370066306E-03 6.87915489763E-03 6.96568401415E-03 7.05330153297E-03 7.14202114451E-03 7.23185671138E-03 7.32282227057E-03 7.41493203564E-03 7.50820039893E-03 7.60264193380E-03 7.69827139695E-03 7.79510373066E-03 7.89315406519E-03 7.99243772110E-03 8.09297021167E-03 8.19476724530E-03 8.29784472798E-03 8.40221876578E-03 8.50790566736E-03 8.61492194651E-03 8.72328432474E-03 8.83300973389E-03 8.94411531879E-03 9.05661843990E-03 9.17053667607E-03 9.28588782725E-03 9.40268991730E-03 9.52096119677E-03 9.64072014581E-03 9.76198547698E-03 9.88477613824E-03 1.00091113159E-02 1.01350104375E-02 1.02624931752E-02 1.03915794483E-02 1.05222894268E-02 1.06546435345E-02 1.07886624518E-02 1.09243671197E-02 1.10617787421E-02 1.12009187900E-02 1.13418090042E-02 1.14844713991E-02 1.16289282661E-02 1.17752021767E-02 1.19233159867E-02 1.20732928390E-02 1.22251561680E-02 1.23789297024E-02 1.25346374698E-02 1.26923037998E-02 1.28519533281E-02 1.30136110002E-02 1.31773020755E-02 1.33430521311E-02 1.35108870658E-02 1.36808331040E-02 1.38529168002E-02 1.40271650429E-02 1.42036050586E-02 1.43822644166E-02 1.45631710326E-02 1.47463531737E-02 1.49318394625E-02 1.51196588816E-02 1.53098407781E-02 1.55024148684E-02 1.56974112426E-02 1.58948603693E-02 1.60947931002E-02 1.62972406752E-02 1.65022347273E-02 1.67098072871E-02 1.69199907883E-02 1.71328180725E-02 1.73483223944E-02 1.75665374270E-02 1.77874972667E-02 1.80112364391E-02 1.82377899039E-02 1.84671930604E-02 1.86994817534E-02 1.89346922785E-02 1.91728613877E-02 1.94140262956E-02 1.96582246846E-02 1.99054947111E-02 2.01558750117E-02 2.04094047088E-02 2.06661234169E-02 2.09260712489E-02 2.11892888220E-02 2.14558172646E-02 2.17256982224E-02 2.19989738646E-02 2.22756868913E-02 2.25558805394E-02 2.28395985898E-02 2.31268853738E-02 2.34177857808E-02 2.37123452644E-02 2.40106098502E-02 2.43126261427E-02 2.46184413325E-02 2.49281032038E-02 2.52416601419E-02 2.55591611408E-02 2.58806558107E-02 2.62061943856E-02 2.65358277317E-02 2.68696073550E-02 2.72075854090E-02 2.75498147036E-02 2.78963487128E-02 2.82472415832E-02 2.86025481427E-02 2.89623239084E-02 2.93266250962E-02 2.96955086288E-02 3.00690321451E-02 3.04472540088E-02 3.08302333179E-02 3.12180299137E-02 3.16107043901E-02 3.20083181035E-02 3.24109331816E-02 3.28186125340E-02 3.32314198614E-02 3.36494196658E-02 3.40726772604E-02 3.45012587802E-02 3.49352311918E-02 3.53746623045E-02 3.58196207800E-02 3.62701761442E-02 3.67263987972E-02 3.71883600247E-02 3.76561320092E-02 3.81297878409E-02 3.86094015295E-02 3.90950480156E-02 3.95868031826E-02 4.00847438681E-02 4.05889478763E-02 4.10994939903E-02 4.16164619838E-02 4.21399326341E-02 4.26699877347E-02 4.32067101076E-02 4.37501836170E-02 4.43004931815E-02 4.48577247882E-02 4.54219655057E-02 4.59933034977E-02 4.65718280369E-02 4.71576295190E-02 4.77507994767E-02 4.83514305939E-02 4.89596167206E-02 4.95754528870E-02 5.01990353187E-02 5.08304614518E-02 5.14698299480E-02 5.21172407098E-02 5.27727948965E-02 5.34365949398E-02 5.41087445597E-02 5.47893487811E-02 5.54785139497E-02 5.61763477489E-02 5.68829592168E-02 5.75984587628E-02 5.83229581852E-02 5.90565706884E-02 5.97994109010E-02 6.05515948932E-02 6.13132401952E-02 6.20844658158E-02 6.28653922605E-02 6.36561415507E-02 6.44568372424E-02 6.52676044461E-02 6.60885698458E-02 6.69198617190E-02 6.77616099568E-02 6.86139460839E-02 6.94770032798E-02 7.03509163987E-02 7.12358219915E-02 7.21318583263E-02 7.30391654108E-02 7.39578850135E-02 7.48881606862E-02 7.58301377864E-02 7.67839634998E-02 7.77497868638E-02 7.87277587902E-02 7.97180320890E-02 8.07207614926E-02 8.17361036793E-02 8.27642172986E-02 8.38052629952E-02 8.48594034346E-02 8.59268033285E-02 8.70076294602E-02 8.81020507110E-02 8.92102380865E-02 9.03323647432E-02 9.14686060157E-02 9.26191394439E-02 9.37841448012E-02 9.49638041218E-02 9.61583017301E-02 9.73678242686E-02 9.85925607278E-02 9.98327024752E-02 1.01088443285E-01 1.02359979371E-01 1.03647509411E-01 1.04951234585E-01 1.06271358604E-01 1.07608087738E-01 1.08961630855E-01 1.10332199448E-01 1.11720007673E-01 1.13125272375E-01 1.14548213132E-01 1.15989052280E-01 1.17448014953E-01 1.18925329118E-01 1.20421225607E-01 1.21935938158E-01 1.23469703447E-01 1.25022761128E-01 1.26595353871E-01 1.28187727395E-01 1.29800130512E-01 1.31432815164E-01 1.33086036460E-01 1.34760052720E-01 1.36455125513E-01 1.38171519697E-01 1.39909503462E-01 1.41669348371E-01 1.43451329404E-01 1.45255725000E-01 1.47082817097E-01 1.48932891185E-01 1.50806236339E-01 1.52703145275E-01 1.54623914388E-01 1.56568843802E-01 1.58538237417E-01 1.60532402953E-01 1.62551652005E-01 1.64596300082E-01 1.66666666667E-01 1.68763075257E-01 1.70885853421E-01 1.73035332847E-01 1.75211849396E-01 1.77415743153E-01 1.79647358481E-01 1.81907044074E-01 1.84195153013E-01 1.86512042819E-01 1.88858075511E-01 1.91233617662E-01 1.93639040455E-01 1.96074719741E-01 1.98541036102E-01 2.01038374903E-01 2.03567126360E-01 2.06127685594E-01 2.08720452699E-01 2.11345832798E-01 2.14004236115E-01 2.16696078028E-01 2.19421779145E-01 2.22181765361E-01 2.24976467929E-01 2.27806323529E-01 2.30671774330E-01 2.33573268065E-01 2.36511258099E-01 2.39486203498E-01 2.42498569103E-01 2.45548825603E-01 2.48637449607E-01 2.51764923718E-01 2.54931736611E-01 2.58138383106E-01 2.61385364248E-01 2.64673187386E-01 2.68002366248E-01 2.71373421024E-01 2.74786878450E-01 2.78243271885E-01 2.81743141397E-01 2.85287033847E-01 2.88875502978E-01 2.92509109493E-01 2.96188421152E-01 2.99914012855E-01 3.03686466732E-01 3.07506372237E-01 3.11374326239E-01 3.15290933112E-01 3.19256804836E-01 3.23272561084E-01 3.27338829328E-01 3.31456244930E-01 3.35625451245E-01 3.39847099719E-01 3.44121849994E-01 3.48450370009E-01 3.52833336102E-01 3.57271433122E-01 3.61765354531E-01 3.66315802512E-01 3.70923488082E-01 3.75589131202E-01 3.80313460888E-01 3.85097215326E-01 3.89941141988E-01 3.94845997746E-01 3.99812548995E-01 4.04841571767E-01 4.09933851859E-01 4.15090184950E-01 4.20311376726E-01 4.25598243010E-01 4.30951609886E-01 4.36372313827E-01 4.41861201830E-01 4.47419131545E-01 4.53046971410E-01 4.58745600785E-01 4.64515910094E-01 4.70358800959E-01 4.76275186344E-01 4.82265990695E-01 4.88332150089E-01 4.94474612375E-01 5.00694337324E-01 5.06992296783E-01 5.13369474820E-01 5.19826867881E-01 5.26365484948E-01 5.32986347693E-01 5.39690490640E-01 5.46478961323E-01 5.53352820456E-01 5.60313142093E-01 5.67361013798E-01 5.74497536817E-01 5.81723826244E-01 5.89041011202E-01 5.96450235017E-01 6.03952655394E-01 6.11549444603E-01 6.19241789657E-01 6.27030892500E-01 6.34917970196E-01 6.42904255116E-01 6.50990995134E-01 6.59179453820E-01 6.67470910637E-01 6.75866661141E-01 6.84368017186E-01 6.92976307126E-01 7.01692876024E-01 7.10519085861E-01 7.19456315752E-01 7.28505962155E-01 7.37669439097E-01 7.46948178390E-01 7.56343629855E-01 7.65857261551E-01 7.75490560003E-01 7.85245030432E-01 7.95122196995E-01 8.05123603018E-01 8.15250811243E-01 8.25505404066E-01 8.35888983787E-01 8.46403172863E-01 8.57049614157E-01 8.67829971197E-01 8.78745928435E-01 8.89799191512E-01 9.00991487524E-01 9.12324565288E-01 9.23800195622E-01 9.35420171616E-01 9.47186308914E-01 9.59100446001E-01 9.71164444484E-01 9.83380189387E-01 9.95749589445E-01 1.00827457740E+00 1.02095711031E+00 1.03379916985E+00 1.04680276261E+00 1.05996992043E+00 1.07330270071E+00 1.08680318672E+00 1.10047348794E+00 1.11431574038E+00 1.12833210692E+00 1.14252477765E+00 1.15689597020E+00 1.17144793010E+00 1.18618293112E+00 1.20110327564E+00 1.21621129498E+00 1.23150934982E+00 1.24699983050E+00 1.26268515744E+00 1.27856778150E+00 1.29465018438E+00 1.31093487899E+00 1.32742440984E+00 1.34412135345E+00 1.36102831876E+00 1.37814794751E+00 1.39548291469E+00 1.41303592891E+00 1.43080973286E+00 1.44880710375E+00 1.46703085370E+00 1.48548383020E+00 1.50416891657E+00 1.52308903240E+00 1.54224713398E+00 1.56164621482E+00 1.58128930606E+00 1.60117947697E+00 1.62131983543E+00 1.64171352841E+00 1.66236374247E+00 1.68327370425E+00 1.70444668097E+00 1.72588598095E+00 1.74759495412E+00 1.76957699256E+00 1.79183553101E+00 1.81437404741E+00 1.83719606344E+00 1.86030514509E+00 1.88370490321E+00 1.90739899406E+00 1.93139111987E+00 1.95568502948E+00 1.98028451885E+00 2.00519343171E+00 2.03041566012E+00 2.05595514511E+00 2.08181587727E+00 2.10800189740E+00 2.13451729711E+00 2.16136621949E+00 2.18855285975E+00 2.21608146584E+00 2.24395633917E+00 2.27218183524E+00 2.30076236434E+00 2.32970239225E+00 2.35900644090E+00 2.38867908910E+00 2.41872497327E+00 2.44914878813E+00 2.47995528748E+00 2.51114928489E+00 2.54273565448E+00 2.57471933169E+00 2.60710531403E+00 2.63989866189E+00 2.67310449928E+00 2.70672801468E+00 2.74077446185E+00 2.77524916060E+00 2.81015749768E+00 2.84550492759E+00 2.88129697343E+00 2.91753922778E+00 2.95423735358E+00 2.99139708497E+00 3.02902422824E+00 3.06712466271E+00 3.10570434165E+00 3.14476929321E+00 3.18432562137E+00 3.22437950689E+00 3.26493720827E+00 3.30600506272E+00 3.34758948720E+00 3.38969697934E+00 3.43233411853E+00 3.47550756691E+00 3.51922407042E+00 3.56349045985E+00 3.60831365192E+00 3.65370065033E+00 3.69965854691E+00 3.74619452266E+00 3.79331584892E+00 3.84102988851E+00 3.88934409682E+00 3.93826602307E+00 3.98780331140E+00 4.03796370210E+00 4.08875503285E+00 4.14018523989E+00 4.19226235930E+00 4.24499452824E+00 4.29838998620E+00 4.35245707634E+00 4.40720424676E+00 4.46264005181E+00 4.51877315344E+00 4.57561232258E+00 4.63316644044E+00 4.69144450000E+00 4.75045560729E+00 4.81020898295E+00 4.87071396354E+00 4.93198000310E+00 4.99401667457E+00 5.05683367130E+00 5.12044080858E+00 5.18484802516E+00 5.25006538479E+00 5.31610307782E+00 5.38297142277E+00 5.45068086795E+00 5.51924199312E+00 5.58866551107E+00 5.65896226937E+00 5.73014325205E+00 5.80221958127E+00 5.87520251910E+00 5.94910346928E+00 6.02393397897E+00 6.09970574061E+00 6.17643059368E+00 6.25412052660E+00 6.33278767857E+00 6.41244434151E+00 6.49310296191E+00 6.57477614287E+00 6.65747664597E+00 6.74121739334E+00 6.82601146965E+00 6.91187212414E+00 6.99881277271E+00 7.08684700001E+00 7.17598856158E+00 7.26625138595E+00 7.35764957689E+00 7.45019741555E+00 7.54390936271E+00 7.63880006106E+00 7.73488433745E+00 7.83217720526E+00 7.93069386670E+00 8.03044971518E+00 8.13146033778E+00 8.23374151759E+00 8.33730923627E+00 8.44217967647E+00 8.54836922443E+00 8.65589447247E+00 8.76477222163E+00 8.87501948429E+00 8.98665348679E+00 9.09969167219E+00 9.21415170292E+00 9.33005146361E+00 9.44740906381E+00 9.56624284091E+00 9.68657136291E+00 9.80841343139E+00 9.93178808443E+00 1.00567145996E+01 1.01832124968E+01 1.03113015417E+01 1.04410017485E+01 1.05723333830E+01 1.07053169662E+01 1.08399732768E+01 1.09763233554E+01 1.11143885068E+01 1.12541903041E+01 1.13957505914E+01 1.15390914880E+01 1.16842353911E+01 1.18312049798E+01 1.19800232183E+01 1.21307133598E+01 1.22832989499E+01 1.24378038305E+01 1.25942521433E+01 1.27526683336E+01 1.29130771542E+01 1.30755036694E+01 1.32399732587E+01 1.34065116207E+01 1.35751447775E+01 1.37458990782E+01 1.39188012037E+01 1.40938781701E+01 1.42711573337E+01 1.44506663947E+01 1.46324334016E+01 1.48164867561E+01 1.50028552168E+01 1.51915679041E+01 1.53826543048E+01 1.55761442765E+01 1.57720680525E+01 1.59704562462E+01 1.61713398562E+01 1.63747502709E+01 1.65807192737E+01 1.67892790475E+01 1.70004621804E+01 1.72143016702E+01 1.74308309295E+01 1.76500837917E+01 1.78720945153E+01 1.80968977901E+01 1.83245287420E+01 1.85550229388E+01 1.87884163957E+01 1.90247455808E+01 1.92640474212E+01 1.95063593082E+01 1.97517191035E+01 2.00001651450E+01 2.02517362531E+01 2.05064717362E+01 2.07644113972E+01 2.10255955397E+01 2.12900649743E+01 2.15578610249E+01 2.18290255351E+01 2.21036008750E+01 2.23816299475E+01 2.26631561952E+01 2.29482236071E+01 2.32368767257E+01 2.35291606536E+01 2.38251210607E+01 2.41248041914E+01 2.44282568718E+01 2.47355265171E+01 2.50466611387E+01 2.53617093521E+01 2.56807203842E+01 2.60037440811E+01 2.63308309159E+01 2.66620319966E+01 2.69973990740E+01 2.73369845500E+01 2.76808414854E+01 2.80290236086E+01 2.83815853238E+01 2.87385817195E+01 2.91000685770E+01 2.94661023794E+01 2.98367403203E+01 3.02120403125E+01 3.05920609975E+01 3.09768617543E+01 3.13665027088E+01 3.17610447431E+01 3.21605495053E+01 3.25650794188E+01 3.29746976921E+01 3.33894683291E+01 3.38094561385E+01 3.42347267441E+01 3.46653465955E+01 3.51013829778E+01 3.55429040226E+01 3.59899787184E+01 3.64426769217E+01 3.69010693674E+01 3.73652276802E+01 3.78352243859E+01 3.83111329223E+01 3.87930276513E+01 3.92809838697E+01 3.97750778218E+01 4.02753867107E+01 4.07819887107E+01 4.12949629794E+01 4.18143896701E+01 4.23403499443E+01 4.28729259843E+01 4.34122010062E+01 4.39582592728E+01 4.45111861069E+01 4.50710679044E+01 4.56379921479E+01 4.62120474205E+01 4.67933234196E+01 4.73819109707E+01 4.79779020417E+01 4.85813897576E+01 4.91924684144E+01 4.98112334945E+01 5.04377816812E+01 5.10722108739E+01 5.17146202034E+01 5.23651100476E+01 5.30237820468E+01 5.36907391197E+01 5.43660854799E+01 5.50499266516E+01 5.57423694863E+01 5.64435221797E+01 5.71534942882E+01 5.78723967465E+01 5.86003418845E+01 5.93374434451E+01 6.00838166020E+01 6.08395779776E+01 6.16048456609E+01 6.23797392267E+01 6.31643797537E+01 6.39588898435E+01 6.47633936400E+01 6.55780168485E+01 6.64028867556E+01 6.72381322488E+01 6.80838838370E+01 6.89402736705E+01 6.98074355621E+01 7.06855050075E+01 7.15746192068E+01 7.24749170861E+01 7.33865393185E+01 7.43096283471E+01 7.52443284063E+01 7.61907855448E+01 7.71491476486E+01 7.81195644637E+01 7.91021876197E+01 8.00971706535E+01 8.11046690331E+01 8.21248401822E+01 8.31578435047E+01 8.42038404095E+01 8.52629943356E+01 8.63354707781E+01 8.74214373135E+01 8.85210636263E+01 8.96345215355E+01 9.07619850210E+01 9.19036302513E+01 9.30596356108E+01 9.42301817278E+01 9.54154515023E+01 9.66156301352E+01 9.78309051570E+01 9.90614664566E+01 1.00307506312E+02 1.89975409491E-06 1.92365005973E-06 1.94784659878E-06 1.97234749284E-06 1.99715657020E-06 2.02227770733E-06 2.04771482948E-06 2.07347191123E-06 2.09955297718E-06 2.12596210256E-06 2.15270341385E-06 2.17978108942E-06 2.20719936022E-06 2.23496251042E-06 2.26307487805E-06 2.29154085574E-06 2.32036489134E-06 2.34955148869E-06 2.37910520823E-06 2.40903066780E-06 2.43933254331E-06 2.47001556950E-06 2.50108454065E-06 2.53254431134E-06 2.56439979724E-06 2.59665597582E-06 2.62931788718E-06 2.66239063481E-06 2.69587938639E-06 2.72978937461E-06 2.76412589797E-06 2.79889432163E-06 2.83410007822E-06 2.86974866872E-06 2.90584566328E-06 2.94239670214E-06 2.97940749647E-06 3.01688382929E-06 3.05483155634E-06 3.09325660704E-06 3.13216498537E-06 3.17156277086E-06 3.21145611948E-06 3.25185126465E-06 3.29275451820E-06 3.33417227134E-06 3.37611099569E-06 3.41857724424E-06 3.46157765245E-06 3.50511893920E-06 3.54920790792E-06 3.59385144760E-06 3.63905653388E-06 3.68483023014E-06 3.73117968863E-06 3.77811215153E-06 3.82563495214E-06 3.87375551600E-06 3.92248136204E-06 3.97182010377E-06 4.02177945047E-06 4.07236720840E-06 4.12359128199E-06 4.17545967510E-06 4.22798049228E-06 4.28116194002E-06 4.33501232802E-06 4.38954007052E-06 4.44475368758E-06 4.50066180645E-06 4.55727316288E-06 4.61459660252E-06 4.67264108226E-06 4.73141567168E-06 4.79092955443E-06 4.85119202966E-06 4.91221251352E-06 4.97400054058E-06 5.03656576534E-06 5.09991796375E-06 5.16406703472E-06 5.22902300167E-06 5.29479601410E-06 5.36139634918E-06 5.42883441335E-06 5.49712074394E-06 5.56626601083E-06 5.63628101811E-06 5.70717670577E-06 5.77896415139E-06 5.85165457193E-06 5.92525932539E-06 5.99978991268E-06 6.07525797935E-06 6.15167531744E-06 6.22905386732E-06 6.30740571953E-06 6.38674311672E-06 6.46707845552E-06 6.54842428848E-06 6.63079332606E-06 6.71419843859E-06 6.79865265828E-06 6.88416918129E-06 6.97076136973E-06 7.05844275382E-06 7.14722703395E-06 7.23712808285E-06 7.32815994773E-06 7.42033685252E-06 7.51367320003E-06 7.60818357427E-06 7.70388274267E-06 7.80078565843E-06 7.89890746281E-06 7.99826348755E-06 8.09886925724E-06 8.20074049173E-06 8.30389310860E-06 8.40834322567E-06 8.51410716347E-06 8.62120144783E-06 8.72964281247E-06 8.83944820155E-06 8.95063477240E-06 9.06321989814E-06 9.17722117043E-06 9.29265640220E-06 9.40954363044E-06 9.52790111902E-06 9.64774736153E-06 9.76910108419E-06 9.89198124877E-06 1.00164070556E-05 1.01423979463E-05 1.02699736074E-05 1.03991539727E-05 1.05299592270E-05 1.06624098089E-05 1.07965264140E-05 1.09323299983E-05 1.10698417814E-05 1.12090832498E-05 1.13500761603E-05 1.14928425433E-05 1.16374047062E-05 1.17837852374E-05 1.19320070090E-05 1.20820931809E-05 1.22340672045E-05 1.23879528260E-05 1.25437740903E-05 1.27015553448E-05 1.28613212432E-05 1.30230967492E-05 1.31869071406E-05 1.33527780130E-05 1.35207352842E-05 1.36908051978E-05 1.38630143275E-05 1.40373895814E-05 1.42139582060E-05 1.43927477905E-05 1.45737862712E-05 1.47571019355E-05 1.49427234271E-05 1.51306797496E-05 1.53210002716E-05 1.55137147311E-05 1.57088532401E-05 1.59064462893E-05 1.61065247531E-05 1.63091198942E-05 1.65142633685E-05 1.67219872300E-05 1.69323239360E-05 1.71453063521E-05 1.73609677572E-05 1.75793418489E-05 1.78004627484E-05 1.80243650065E-05 1.82510836083E-05 1.84806539790E-05 1.87131119895E-05 1.89484939619E-05 1.91868366749E-05 1.94281773703E-05 1.96725537578E-05 1.99200040220E-05 2.01705668272E-05 2.04242813246E-05 2.06811871575E-05 2.09413244680E-05 2.12047339030E-05 2.14714566208E-05 2.17415342974E-05 2.20150091330E-05 2.22919238586E-05 2.25723217426E-05 2.28562465978E-05 2.31437427880E-05 2.34348552351E-05 2.37296294261E-05 2.40281114199E-05 2.43303478550E-05 2.46363859565E-05 2.49462735433E-05 2.52600590362E-05 2.55777914647E-05 2.58995204752E-05 2.62252963384E-05 2.65551699575E-05 2.68891928760E-05 2.72274172856E-05 2.75698960345E-05 2.79166826357E-05 2.82678312754E-05 2.86233968213E-05 2.89834348311E-05 2.93480015616E-05 2.97171539771E-05 3.00909497583E-05 3.04694473117E-05 3.08527057781E-05 3.12407850427E-05 3.16337457434E-05 3.20316492813E-05 3.24345578295E-05 3.28425343434E-05 3.32556425702E-05 3.36739470587E-05 3.40975131699E-05 3.45264070870E-05 3.49606958254E-05 3.54004472437E-05 3.58457300539E-05 3.62966138323E-05 3.67531690305E-05 3.72154669861E-05 3.76835799341E-05 3.81575810182E-05 3.86375443019E-05 3.91235447806E-05 3.96156583927E-05 4.01139620321E-05 4.06185335596E-05 4.11294518156E-05 4.16467966322E-05 4.21706488454E-05 4.27010903084E-05 4.32382039035E-05 4.37820735560E-05 4.43327842466E-05 4.48904220249E-05 4.54550740230E-05 4.60268284689E-05 4.66057747003E-05 4.71920031789E-05 4.77856055040E-05 4.83866744272E-05 4.89953038667E-05 4.96115889221E-05 5.02356258892E-05 5.08675122751E-05 5.15073468132E-05 5.21552294791E-05 5.28112615057E-05 5.34755453993E-05 5.41481849557E-05 5.48292852762E-05 5.55189527841E-05 5.62172952413E-05 5.69244217652E-05 5.76404428458E-05 5.83654703630E-05 5.90996176036E-05 5.98429992797E-05 6.05957315462E-05 6.13579320190E-05 6.21297197935E-05 6.29112154632E-05 6.37025411382E-05 6.45038204650E-05 6.53151786449E-05 6.61367424543E-05 6.69686402643E-05 6.78110020606E-05 6.86639594640E-05 6.95276457507E-05 7.04021958735E-05 7.12877464826E-05 7.21844359472E-05 7.30924043768E-05 7.40117936432E-05 7.49427474030E-05 7.58854111195E-05 7.68399320859E-05 7.78064594480E-05 7.87851442278E-05 7.97761393466E-05 8.07795996494E-05 8.17956819291E-05 8.28245449505E-05 8.38663494755E-05 8.49212582883E-05 8.59894362204E-05 8.70710501769E-05 8.81662691622E-05 8.92752643063E-05 9.03982088922E-05 9.15352783821E-05 9.26866504455E-05 9.38525049866E-05 9.50330241725E-05 9.62283924618E-05 9.74387966332E-05 9.86644258149E-05 9.99054715138E-05 1.01162127646E-04 1.02434590566E-04 1.03723059100E-04 1.05027734572E-04 1.06348820842E-04 1.07686524331E-04 1.09041054059E-04 1.10412621674E-04 1.11801441485E-04 1.13207730499E-04 1.14631708451E-04 1.16073597841E-04 1.17533623966E-04 1.19012014960E-04 1.20509001823E-04 1.22024818462E-04 1.23559701728E-04 1.25113891449E-04 1.26687630469E-04 1.28281164690E-04 1.29894743103E-04 1.31528617835E-04 1.33183044181E-04 1.34858280648E-04 1.36554588996E-04 1.38272234276E-04 1.40011484874E-04 1.41772612552E-04 1.43555892489E-04 1.45361603326E-04 1.47190027209E-04 1.49041449834E-04 1.50916160488E-04 1.52814452099E-04 1.54736621280E-04 1.56682968372E-04 1.58653797497E-04 1.60649416601E-04 1.62670137502E-04 1.64716275944E-04 1.66788151639E-04 1.68886088322E-04 1.71010413800E-04 1.73161460003E-04 1.75339563036E-04 1.77545063233E-04 1.79778305207E-04 1.82039637907E-04 1.84329414671E-04 1.86647993281E-04 1.88995736020E-04 1.91373009727E-04 1.93780185856E-04 1.96217640533E-04 1.98685754616E-04 2.01184913752E-04 2.03715508440E-04 2.06277934091E-04 2.08872591089E-04 2.11499884854E-04 2.14160225907E-04 2.16854029930E-04 2.19581717837E-04 2.22343715834E-04 2.25140455489E-04 2.27972373798E-04 2.30839913255E-04 2.33743521917E-04 2.36683653481E-04 2.39660767347E-04 2.42675328695E-04 2.45727808557E-04 2.48818683889E-04 2.51948437647E-04 2.55117558860E-04 2.58326542712E-04 2.61575890611E-04 2.64866110275E-04 2.68197715808E-04 2.71571227780E-04 2.74987173308E-04 2.78446086142E-04 2.81948506743E-04 2.85494982372E-04 2.89086067173E-04 2.92722322260E-04 2.96404315805E-04 3.00132623128E-04 3.03907826784E-04 3.07730516656E-04 3.11601290047E-04 3.15520751774E-04 3.19489514260E-04 3.23508197633E-04 3.27577429820E-04 3.31697846647E-04 3.35870091937E-04 3.40094817612E-04 3.44372683795E-04 3.48704358910E-04 3.53090519791E-04 3.57531851783E-04 3.62029048855E-04 3.66582813702E-04 3.71193857860E-04 3.75862901813E-04 3.80590675110E-04 3.85377916474E-04 3.90225373921E-04 3.95133804877E-04 4.00103976293E-04 4.05136664770E-04 4.10232656675E-04 4.15392748268E-04 4.20617745822E-04 4.25908465755E-04 4.31265734752E-04 4.36690389898E-04 4.42183278806E-04 4.47745259750E-04 4.53377201803E-04 4.59079984965E-04 4.64854500309E-04 4.70701650115E-04 4.76622348011E-04 4.82617519119E-04 4.88688100195E-04 4.94835039782E-04 5.01059298351E-04 5.07361848454E-04 5.13743674878E-04 5.20205774797E-04 5.26749157927E-04 5.33374846684E-04 5.40083876346E-04 5.46877295212E-04 5.53756164769E-04 5.60721559852E-04 5.67774568821E-04 5.74916293721E-04 5.82147850461E-04 5.89470368988E-04 5.96884993459E-04 6.04392882424E-04 6.11995209007E-04 6.19693161087E-04 6.27487941484E-04 6.35380768148E-04 6.43372874350E-04 6.51465508873E-04 6.59659936206E-04 6.67957436747E-04 6.76359306997E-04 6.84866859764E-04 6.93481424371E-04 7.02204346862E-04 7.11036990210E-04 7.19980734535E-04 7.29036977315E-04 7.38207133605E-04 7.47492636262E-04 7.56894936165E-04 7.66415502441E-04 7.76055822698E-04 7.85817403257E-04 7.95701769383E-04 8.05710465530E-04 8.15845055577E-04 8.26107123073E-04 8.36498271488E-04 8.47020124460E-04 8.57674326049E-04 8.68462540997E-04 8.79386454984E-04 8.90447774893E-04 9.01648229079E-04 9.12989567635E-04 9.24473562669E-04 9.36102008578E-04 9.47876722330E-04 9.59799543748E-04 9.71872335798E-04 9.84096984877E-04 9.96475401113E-04 1.00900951866E-03 1.02170129599E-03 1.03455271623E-03 1.04756578744E-03 1.06074254293E-03 1.07408504161E-03 1.08759536825E-03 1.10127563389E-03 1.11512797608E-03 1.12915455929E-03 1.14335757520E-03 1.15773924305E-03 1.17230181001E-03 1.18704755152E-03 1.20197877163E-03 1.21709780336E-03 1.23240700910E-03 1.24790878094E-03 1.26360554107E-03 1.27949974213E-03 1.29559386764E-03 1.31189043232E-03 1.32839198255E-03 1.34510109672E-03 1.36202038569E-03 1.37915249311E-03 1.39650009591E-03 1.41406590469E-03 1.43185266415E-03 1.44986315350E-03 1.46810018691E-03 1.48656661397E-03 1.50526532009E-03 1.52419922697E-03 1.54337129309E-03 1.56278451411E-03 1.58244192339E-03 1.60234659243E-03 1.62250163140E-03 1.64291018954E-03 1.66357545575E-03 1.68450065900E-03 1.70568906891E-03 1.72714399621E-03 1.74886879327E-03 1.77086685464E-03 1.79314161755E-03 1.81569656249E-03 1.83853521372E-03 1.86166113981E-03 1.88507795424E-03 1.90878931594E-03 1.93279892985E-03 1.95711054753E-03 1.98172796771E-03 2.00665503692E-03 2.03189565006E-03 2.05745375103E-03 2.08333333333E-03 2.10953844071E-03 2.13607316776E-03 2.16294166059E-03 2.19014811745E-03 2.21769678941E-03 2.24559198101E-03 2.27383805092E-03 2.30243941266E-03 2.33140053523E-03 2.36072594389E-03 2.39042022078E-03 2.42048800568E-03 2.45093399677E-03 2.48176295128E-03 2.51297968629E-03 2.54458907950E-03 2.57659606993E-03 2.60900565873E-03 2.64182290998E-03 2.67505295143E-03 2.70870097535E-03 2.74277223931E-03 2.77727206701E-03 2.81220584912E-03 2.84757904411E-03 2.88339717913E-03 2.91966585082E-03 2.95639072624E-03 2.99357754372E-03 3.03123211379E-03 3.06936032004E-03 3.10796812009E-03 3.14706154647E-03 3.18664670763E-03 3.22672978882E-03 3.26731705310E-03 3.30841484232E-03 3.35002957810E-03 3.39216776280E-03 3.43483598063E-03 3.47804089856E-03 3.52178926746E-03 3.56608792309E-03 3.61094378722E-03 3.65636386867E-03 3.70235526440E-03 3.74892516068E-03 3.79608083415E-03 3.84382965296E-03 3.89217907798E-03 3.94113666390E-03 3.99071006045E-03 4.04090701355E-03 4.09173536660E-03 4.14320306163E-03 4.19531814056E-03 4.24808874649E-03 4.30152312493E-03 4.35562962511E-03 4.41041670128E-03 4.46589291403E-03 4.52206693163E-03 4.57894753140E-03 4.63654360103E-03 4.69486414003E-03 4.75391826110E-03 4.81371519158E-03 4.87426427485E-03 4.93557497182E-03 4.99765686243E-03 5.06051964709E-03 5.12417314824E-03 5.18862731187E-03 5.25389220908E-03 5.31997803763E-03 5.38689512357E-03 5.45465392284E-03 5.52326502288E-03 5.59273914432E-03 5.66308714262E-03 5.73432000982E-03 5.80644887618E-03 5.87948501199E-03 5.95343982930E-03 6.02832488369E-03 6.10415187611E-03 6.18093265468E-03 6.25867921656E-03 6.33740370979E-03 6.41711843525E-03 6.49783584851E-03 6.57956856185E-03 6.66232934617E-03 6.74613113300E-03 6.83098701654E-03 6.91691025570E-03 7.00391427616E-03 7.09201267248E-03 7.18121921021E-03 7.27154782805E-03 7.36301264003E-03 7.45562793771E-03 7.54940819243E-03 7.64436805754E-03 7.74052237071E-03 7.83788615625E-03 7.93647462745E-03 8.03630318895E-03 8.13738743918E-03 8.23974317275E-03 8.34338638296E-03 8.44833326426E-03 8.55460021482E-03 8.66220383908E-03 8.77116095030E-03 8.88148857327E-03 8.99320394690E-03 9.10632452694E-03 9.22086798871E-03 9.33685222987E-03 9.45429537319E-03 9.57321576939E-03 9.69363200003E-03 9.81556288040E-03 9.93902746243E-03 1.00640450377E-02 1.01906351405E-02 1.03188175508E-02 1.04486122973E-02 1.05800396608E-02 1.07131201770E-02 1.08478746400E-02 1.09843241054E-02 1.11224898939E-02 1.12623935940E-02 1.14040570661E-02 1.15475024453E-02 1.16927521452E-02 1.18398288614E-02 1.19887555750E-02 1.21395555560E-02 1.22922523673E-02 1.24468698681E-02 1.26034322175E-02 1.27619638789E-02 1.29224896231E-02 1.30850345326E-02 1.32496240054E-02 1.34162837589E-02 1.35850398340E-02 1.37559185993E-02 1.39289467547E-02 1.41041513365E-02 1.42815597206E-02 1.44611996275E-02 1.46430991262E-02 1.48272866390E-02 1.50137909455E-02 1.52026411873E-02 1.53938668728E-02 1.55874978813E-02 1.57835644680E-02 1.59820972688E-02 1.61831273048E-02 1.63866859874E-02 1.65928051230E-02 1.68015169182E-02 1.70128539845E-02 1.72268493439E-02 1.74435364336E-02 1.76629491113E-02 1.78851216608E-02 1.81100887969E-02 1.83378856712E-02 1.85685478775E-02 1.88021114572E-02 1.90386129050E-02 1.92780891748E-02 1.95205776853E-02 1.97661163257E-02 2.00147434621E-02 2.02664979428E-02 2.05214191051E-02 2.07795467809E-02 2.10409213031E-02 2.13055835121E-02 2.15735747618E-02 2.18449369265E-02 2.21197124071E-02 2.23979441377E-02 2.26796755926E-02 2.29649507930E-02 2.32538143137E-02 2.35463112902E-02 2.38424874257E-02 2.41423889984E-02 2.44460628685E-02 2.47535564856E-02 2.50649178963E-02 2.53801957515E-02 2.56994393138E-02 2.60226984658E-02 2.63500237175E-02 2.66814662139E-02 2.70170777437E-02 2.73569107469E-02 2.77010183230E-02 2.80494542396E-02 2.84022729405E-02 2.87595295543E-02 2.91212799031E-02 2.94875805112E-02 2.98584886137E-02 3.02340621658E-02 3.06143598516E-02 3.09994410935E-02 3.13893660611E-02 3.17841956810E-02 3.21839916461E-02 3.25888164254E-02 3.29987332736E-02 3.34138062409E-02 3.38341001835E-02 3.42596807731E-02 3.46906145075E-02 3.51269687210E-02 3.55688115948E-02 3.60162121678E-02 3.64692403473E-02 3.69279669197E-02 3.73924635621E-02 3.78628028530E-02 3.83390582839E-02 3.88213042706E-02 3.93096161651E-02 3.98040702671E-02 4.03047438361E-02 4.08117151033E-02 4.13250632840E-02 4.18448685900E-02 4.23712122418E-02 4.29041764817E-02 4.34438445864E-02 4.39903008803E-02 4.45436307482E-02 4.51039206490E-02 4.56712581292E-02 4.62457318363E-02 4.68274315332E-02 4.74164481115E-02 4.80128736063E-02 4.86168012103E-02 4.92283252884E-02 4.98475413924E-02 5.04745462763E-02 5.11094379106E-02 5.17523154987E-02 5.24032794913E-02 5.30624316029E-02 5.37298748275E-02 5.44057134543E-02 5.50900530845E-02 5.57830006476E-02 5.64846644180E-02 5.71951540322E-02 5.79145805056E-02 5.86430562499E-02 5.93806950912E-02 6.01276122868E-02 6.08839245442E-02 6.16497500387E-02 6.24252084321E-02 6.32104208913E-02 6.40055101073E-02 6.48106003145E-02 6.56258173099E-02 6.64512884727E-02 6.72871427846E-02 6.81335108494E-02 6.89905249139E-02 6.98583188883E-02 7.07370283672E-02 7.16267906506E-02 7.25277447658E-02 7.34400314887E-02 7.43637933659E-02 7.52991747372E-02 7.62463217577E-02 7.72053824210E-02 7.81765065825E-02 7.91598459822E-02 8.01555542688E-02 8.11637870239E-02 8.21847017858E-02 8.32184580746E-02 8.42652174168E-02 8.53251433706E-02 8.63984015517E-02 8.74851596588E-02 8.85855875001E-02 8.96998570197E-02 9.08281423244E-02 9.19706197112E-02 9.31274676944E-02 9.42988670339E-02 9.54850007632E-02 9.66860542182E-02 9.79022150658E-02 9.91336733337E-02 1.00380621440E-01 1.01643254222E-01 1.02921768970E-01 1.04216365453E-01 1.05527245956E-01 1.06854615305E-01 1.08198680906E-01 1.09559652770E-01 1.10937743554E-01 1.12333168585E-01 1.13746145902E-01 1.15176896287E-01 1.16625643295E-01 1.18092613298E-01 1.19578035511E-01 1.21082142036E-01 1.22605167892E-01 1.24147351055E-01 1.25708932495E-01 1.27290156210E-01 1.28891269272E-01 1.30512521856E-01 1.32154167288E-01 1.33816462077E-01 1.35499665960E-01 1.37204041943E-01 1.38929856335E-01 1.40677378801E-01 1.42446882393E-01 1.44238643600E-01 1.46052942389E-01 1.47890062247E-01 1.49750290228E-01 1.51633916997E-01 1.53541236874E-01 1.55472547882E-01 1.57428151791E-01 1.59408354170E-01 1.61413464428E-01 1.63443795868E-01 1.65499665734E-01 1.67581395259E-01 1.69689309719E-01 1.71823738478E-01 1.73985015046E-01 1.76173477126E-01 1.78389466671E-01 1.80633329933E-01 1.82905417520E-01 1.85206084451E-01 1.87535690209E-01 1.89894598801E-01 1.92283178810E-01 1.94701803456E-01 1.97150850656E-01 1.99630703077E-01 2.02141748202E-01 2.04684378386E-01 2.07258990921E-01 2.09865988094E-01 2.12505777256E-01 2.15178770877E-01 2.17885386619E-01 2.20626047396E-01 2.23401181442E-01 2.26211222377E-01 2.29056609275E-01 2.31937786735E-01 2.34855204946E-01 2.37809319760E-01 2.40800592765E-01 2.43829491352E-01 2.46896488793E-01 2.50002064313E-01 2.53146703164E-01 2.56330896702E-01 2.59555142465E-01 2.62819944247E-01 2.66125812179E-01 2.69473262811E-01 2.72862819189E-01 2.76295010938E-01 2.79770374344E-01 2.83289452440E-01 2.86852795089E-01 2.90460959072E-01 2.94114508170E-01 2.97814013258E-01 3.01560052392E-01 3.05353210898E-01 3.09194081464E-01 3.13083264234E-01 3.17021366901E-01 3.21009004802E-01 3.25046801013E-01 3.29135386448E-01 3.33275399957E-01 3.37467488425E-01 3.41712306875E-01 3.46010518568E-01 3.50362795108E-01 3.54769816548E-01 3.59232271493E-01 3.63750857212E-01 3.68326279743E-01 3.72959254003E-01 3.77650503907E-01 3.82400762469E-01 3.87210771929E-01 3.92081283860E-01 3.97013059289E-01 4.02006868816E-01 4.07063492734E-01 4.12183721152E-01 4.17368354114E-01 4.22618201731E-01 4.27934084302E-01 4.33316832444E-01 4.38767287222E-01 4.44286300282E-01 4.49874733980E-01 4.55533461521E-01 4.61263367092E-01 4.67065346002E-01 4.72940304823E-01 4.78889161529E-01 4.84912845641E-01 4.91012298371E-01 4.97188472772E-01 5.03442333884E-01 5.09774858884E-01 5.16187037243E-01 5.22679870877E-01 5.29254374304E-01 5.35911574804E-01 5.42652512577E-01 5.49478240910E-01 5.56389826336E-01 5.63388348804E-01 5.70474901848E-01 5.77650592757E-01 5.84916542745E-01 5.92273887133E-01 5.99723775521E-01 6.07267371969E-01 6.14905855180E-01 6.22640418681E-01 6.30472271015E-01 6.38402635924E-01 6.46432752543E-01 6.54563875595E-01 6.62797275585E-01 6.71134238997E-01 6.79576068499E-01 6.88124083145E-01 6.96779618579E-01 7.05544027246E-01 7.14418678602E-01 7.23404959331E-01 7.32504273556E-01 7.41718043064E-01 7.51047707526E-01 7.60494724719E-01 7.70060570761E-01 7.79746740334E-01 7.89554746921E-01 7.99486123044E-01 8.09542420500E-01 8.19725210606E-01 8.30036084445E-01 8.40476653110E-01 8.51048547962E-01 8.61753420881E-01 8.72592944526E-01 8.83568812593E-01 8.94682740085E-01 9.05936463576E-01 9.17331741482E-01 9.28870354339E-01 9.40554105078E-01 9.52384819310E-01 9.64364345608E-01 9.76494555797E-01 9.88777345246E-01 1.00121463317E+00 1.01380836291E+00 1.02656050228E+00 1.03947304381E+00 1.05254800512E+00 1.06578742919E+00 1.07919338473E+00 1.09276796642E+00 1.10651329533E+00 1.12043151919E+00 1.13452481276E+00 1.14879537814E+00 1.16324544514E+00 1.17787727160E+00 1.19269314378E+00 1.20769537669E+00 1.22288631446E+00 1.23826833071E+00 1.25384382890E+00 -1.86035967774E+01 -1.86035969009E+01 -1.86035970267E+01 -1.86035971549E+01 -1.86035972857E+01 -1.86035974192E+01 -1.86035975554E+01 -1.86035976991E+01 -1.86035978405E+01 -1.86035979854E+01 -1.86035981340E+01 -1.86035982864E+01 -1.86035984426E+01 -1.86035986028E+01 -1.86035987670E+01 -1.86035989354E+01 -1.86035991081E+01 -1.86035992851E+01 -1.86035994666E+01 -1.86035996527E+01 -1.86035998454E+01 -1.86036000408E+01 -1.86036002410E+01 -1.86036004464E+01 -1.86036006580E+01 -1.86036008736E+01 -1.86036010947E+01 -1.86036013213E+01 -1.86036015537E+01 -1.86036017920E+01 -1.86036020364E+01 -1.86036022869E+01 -1.86036025437E+01 -1.86036028071E+01 -1.86036030771E+01 -1.86036033540E+01 -1.86036036378E+01 -1.86036039289E+01 -1.86036042273E+01 -1.86036045333E+01 -1.86036048470E+01 -1.86036051687E+01 -1.86036054985E+01 -1.86036058367E+01 -1.86036061766E+01 -1.86036065317E+01 -1.86036068957E+01 -1.86036072637E+01 -1.86036076460E+01 -1.86036080380E+01 -1.86036084399E+01 -1.86036088520E+01 -1.86036092745E+01 -1.86036097078E+01 -1.86036101520E+01 -1.86036106074E+01 -1.86036110744E+01 -1.86036115532E+01 -1.86036120441E+01 -1.86036125474E+01 -1.86036130635E+01 -1.86036135926E+01 -1.86036141352E+01 -1.86036146915E+01 -1.86036152618E+01 -1.86036158466E+01 -1.86036164462E+01 -1.86036170610E+01 -1.86036176913E+01 -1.86036183376E+01 -1.86036190003E+01 -1.86036196797E+01 -1.86036203763E+01 -1.86036210906E+01 -1.86036218229E+01 -1.86036225738E+01 -1.86036233437E+01 -1.86036241106E+01 -1.86036249192E+01 -1.86036257334E+01 -1.86036265829E+01 -1.86036274539E+01 -1.86036283470E+01 -1.86036292626E+01 -1.86036302015E+01 -1.86036311641E+01 -1.86036321510E+01 -1.86036331630E+01 -1.86036342005E+01 -1.86036352644E+01 -1.86036363551E+01 -1.86036374735E+01 -1.86036386202E+01 -1.86036397959E+01 -1.86036410014E+01 -1.86036422374E+01 -1.86036435046E+01 -1.86036448040E+01 -1.86036461362E+01 -1.86036475022E+01 -1.86036489027E+01 -1.86036503387E+01 -1.86036518110E+01 -1.86036533206E+01 -1.86036548685E+01 -1.86036564554E+01 -1.86036580826E+01 -1.86036597510E+01 -1.86036614615E+01 -1.86036632154E+01 -1.86036650137E+01 -1.86036668575E+01 -1.86036687479E+01 -1.86036706862E+01 -1.86036726736E+01 -1.86036747113E+01 -1.86036768005E+01 -1.86036789427E+01 -1.86036811390E+01 -1.86036833909E+01 -1.86036856999E+01 -1.86036880672E+01 -1.86036904945E+01 -1.86036929833E+01 -1.86036955350E+01 -1.86036981513E+01 -1.86037008338E+01 -1.86037035843E+01 -1.86037064043E+01 -1.86037092957E+01 -1.86037122603E+01 -1.86037152999E+01 -1.86037184164E+01 -1.86037215346E+01 -1.86037247706E+01 -1.86037281266E+01 -1.86037315676E+01 -1.86037350957E+01 -1.86037387129E+01 -1.86037424218E+01 -1.86037462246E+01 -1.86037501236E+01 -1.86037541213E+01 -1.86037582201E+01 -1.86037624226E+01 -1.86037667315E+01 -1.86037711495E+01 -1.86037756792E+01 -1.86037803236E+01 -1.86037850856E+01 -1.86037899680E+01 -1.86037949740E+01 -1.86038001066E+01 -1.86038053691E+01 -1.86038107649E+01 -1.86038162972E+01 -1.86038219694E+01 -1.86038277851E+01 -1.86038337480E+01 -1.86038398619E+01 -1.86038461304E+01 -1.86038525575E+01 -1.86038591472E+01 -1.86038659038E+01 -1.86038728313E+01 -1.86038799340E+01 -1.86038872164E+01 -1.86038946830E+01 -1.86039023386E+01 -1.86039101879E+01 -1.86039182357E+01 -1.86039264872E+01 -1.86039349474E+01 -1.86039436217E+01 -1.86039525154E+01 -1.86039616341E+01 -1.86039709834E+01 -1.86039805693E+01 -1.86039903976E+01 -1.86040004747E+01 -1.86040108066E+01 -1.86040213998E+01 -1.86040322610E+01 -1.86040433970E+01 -1.86040548146E+01 -1.86040665209E+01 -1.86040785234E+01 -1.86040908294E+01 -1.86041034466E+01 -1.86041163829E+01 -1.86041296464E+01 -1.86041432454E+01 -1.86041571883E+01 -1.86041714837E+01 -1.86041861406E+01 -1.86042011681E+01 -1.86042165756E+01 -1.86042323727E+01 -1.86042485692E+01 -1.86042651753E+01 -1.86042822011E+01 -1.86042996575E+01 -1.86043175551E+01 -1.86043359052E+01 -1.86043547192E+01 -1.86043740088E+01 -1.86043937860E+01 -1.86044140630E+01 -1.86044348526E+01 -1.86044561677E+01 -1.86044780215E+01 -1.86045004276E+01 -1.86045233998E+01 -1.86045469527E+01 -1.86045711007E+01 -1.86045958588E+01 -1.86046212425E+01 -1.86046472677E+01 -1.86046739503E+01 -1.86047013069E+01 -1.86047293547E+01 -1.86047581110E+01 -1.86047875936E+01 -1.86048178209E+01 -1.86048488116E+01 -1.86048805851E+01 -1.86049131608E+01 -1.86049465591E+01 -1.86049808008E+01 -1.86050159071E+01 -1.86050518997E+01 -1.86050888009E+01 -1.86051266337E+01 -1.86051654214E+01 -1.86052051881E+01 -1.86052459584E+01 -1.86052877576E+01 -1.86053306116E+01 -1.86053745468E+01 -1.86054195905E+01 -1.86054657706E+01 -1.86055131155E+01 -1.86055616547E+01 -1.86056114180E+01 -1.86056624363E+01 -1.86057147410E+01 -1.86057683646E+01 -1.86058233400E+01 -1.86058797012E+01 -1.86059374831E+01 -1.86059967213E+01 -1.86060574522E+01 -1.86061197133E+01 -1.86061835431E+01 -1.86062489808E+01 -1.86063160667E+01 -1.86063848422E+01 -1.86064553495E+01 -1.86065276320E+01 -1.86066017342E+01 -1.86066777016E+01 -1.86067555809E+01 -1.86068354199E+01 -1.86069172676E+01 -1.86070011742E+01 -1.86070871913E+01 -1.86071753714E+01 -1.86072657687E+01 -1.86073584384E+01 -1.86074534373E+01 -1.86075508235E+01 -1.86076506567E+01 -1.86077529977E+01 -1.86078579089E+01 -1.86079654546E+01 -1.86080757002E+01 -1.86081887130E+01 -1.86083045617E+01 -1.86084233170E+01 -1.86085450510E+01 -1.86086698378E+01 -1.86087977532E+01 -1.86089288748E+01 -1.86090632821E+01 -1.86092010567E+01 -1.86093422819E+01 -1.86094870432E+01 -1.86096354282E+01 -1.86097875265E+01 -1.86099434298E+01 -1.86101032323E+01 -1.86102670302E+01 -1.86104349222E+01 -1.86106070091E+01 -1.86107833943E+01 -1.86109641837E+01 -1.86111494858E+01 -1.86113394115E+01 -1.86115340743E+01 -1.86117335907E+01 -1.86119380797E+01 -1.86121476633E+01 -1.86123624662E+01 -1.86125826161E+01 -1.86128082438E+01 -1.86130394833E+01 -1.86132764713E+01 -1.86135193482E+01 -1.86137682574E+01 -1.86140233458E+01 -1.86142847635E+01 -1.86145526643E+01 -1.86148272055E+01 -1.86151085479E+01 -1.86153968562E+01 -1.86156922990E+01 -1.86159950486E+01 -1.86163052810E+01 -1.86166231765E+01 -1.86169489197E+01 -1.86172826991E+01 -1.86176247074E+01 -1.86179751418E+01 -1.86183342039E+01 -1.86187020998E+01 -1.86190790403E+01 -1.86194652407E+01 -1.86198609214E+01 -1.86202663074E+01 -1.86206816286E+01 -1.86211071200E+01 -1.86215430219E+01 -1.86219895797E+01 -1.86224470440E+01 -1.86229156710E+01 -1.86233957223E+01 -1.86238874651E+01 -1.86243911721E+01 -1.86249071220E+01 -1.86254355993E+01 -1.86259768943E+01 -1.86265313036E+01 -1.86270991296E+01 -1.86276806810E+01 -1.86282762730E+01 -1.86288862270E+01 -1.86295108708E+01 -1.86301505390E+01 -1.86308055725E+01 -1.86314763192E+01 -1.86321631336E+01 -1.86328663772E+01 -1.86335864183E+01 -1.86343236323E+01 -1.86350784016E+01 -1.86358511159E+01 -1.86366421718E+01 -1.86374519735E+01 -1.86382809323E+01 -1.86391294668E+01 -1.86399980032E+01 -1.86408869751E+01 -1.86417968233E+01 -1.86427279963E+01 -1.86436809503E+01 -1.86446561487E+01 -1.86456540625E+01 -1.86466751704E+01 -1.86477199585E+01 -1.86487889203E+01 -1.86498825569E+01 -1.86510013770E+01 -1.86521458961E+01 -1.86533166377E+01 -1.86545141321E+01 -1.86557389171E+01 -1.86569915371E+01 -1.86582725439E+01 -1.86595824959E+01 -1.86609219582E+01 -1.86622915024E+01 -1.86636917066E+01 -1.86651231549E+01 -1.86665864374E+01 -1.86680821499E+01 -1.86696108936E+01 -1.86711732750E+01 -1.86727699056E+01 -1.86744014012E+01 -1.86760683820E+01 -1.86777714720E+01 -1.86795112986E+01 -1.86812884926E+01 -1.86831036871E+01 -1.86849575173E+01 -1.86868506201E+01 -1.86887836337E+01 -1.86907571965E+01 -1.86927719468E+01 -1.86948285223E+01 -1.86969275592E+01 -1.86990696917E+01 -1.87012555509E+01 -1.87034857644E+01 -1.87057609551E+01 -1.87080817407E+01 -1.87104487324E+01 -1.87128625344E+01 -1.87153237423E+01 -1.87178329425E+01 -1.87203907111E+01 -1.87229976124E+01 -1.87256541980E+01 -1.87283610057E+01 -1.87311185577E+01 -1.87339273597E+01 -1.87367878991E+01 -1.87397006442E+01 -1.87426660421E+01 -1.87456845173E+01 -1.87487564701E+01 -1.87518822753E+01 -1.87550622798E+01 -1.87582968014E+01 -1.87615861269E+01 -1.87649305101E+01 -1.87683301697E+01 -1.87717852880E+01 -1.87752960081E+01 -1.87788624324E+01 -1.87824846203E+01 -1.87861625862E+01 -1.87898962969E+01 -1.87936856701E+01 -1.87975305712E+01 -1.88014308122E+01 -1.88053861481E+01 -1.88093962757E+01 -1.88134608305E+01 -1.88175793846E+01 -1.88217514443E+01 -1.88259764478E+01 -1.88302537625E+01 -1.88345826829E+01 -1.88389624281E+01 -1.88433921396E+01 -1.88478708787E+01 -1.88523976243E+01 -1.88569712707E+01 -1.88615906254E+01 -1.88662544064E+01 -1.88709612412E+01 -1.88757096636E+01 -1.88804981126E+01 -1.88853249298E+01 -1.88901883582E+01 -1.88950865405E+01 -1.89000175171E+01 -1.89049792251E+01 -1.89099694971E+01 -1.89149860596E+01 -1.89200265327E+01 -1.89250884287E+01 -1.89301691517E+01 -1.89352659976E+01 -1.89403761532E+01 -1.89454966968E+01 -1.89506245978E+01 -1.89557567182E+01 -1.89608898121E+01 -1.89660205274E+01 -1.89711454070E+01 -1.89762608899E+01 -1.89813633134E+01 -1.89864489149E+01 -1.89915138345E+01 -1.89965541172E+01 -1.90015657161E+01 -1.90065444960E+01 -1.90114862363E+01 -1.90163866351E+01 -1.90212413136E+01 -1.90260458204E+01 -1.90307956360E+01 -1.90354861784E+01 -1.90401128080E+01 -1.90446708335E+01 -1.90491555178E+01 -1.90535620840E+01 -1.90578857224E+01 -1.90621215964E+01 -1.90662648503E+01 -1.90703106158E+01 -1.90742540195E+01 -1.90780901908E+01 -1.90818142694E+01 -1.90854214127E+01 -1.90889068045E+01 -1.90922656627E+01 -1.90954932473E+01 -1.90985848686E+01 -1.91015358957E+01 -1.91043417642E+01 -1.91069979847E+01 -1.91095001503E+01 -1.91118439453E+01 -1.91140251520E+01 -1.91160396592E+01 -1.91178834689E+01 -1.91195527038E+01 -1.91210436141E+01 -1.91223525840E+01 -1.91234761376E+01 -1.91244109455E+01 -1.91251538293E+01 -1.91257017671E+01 -1.91260518978E+01 -1.91262015255E+01 -1.91261481221E+01 -1.91258893309E+01 -1.91254229689E+01 -1.91247470281E+01 -1.91238596769E+01 -1.91227592603E+01 -1.91214443001E+01 -1.91199134933E+01 -1.91181657114E+01 -1.91161999971E+01 -1.91140155623E+01 -1.91116117835E+01 -1.91089881980E+01 -1.91061444987E+01 -1.91030805279E+01 -1.90997962714E+01 -1.90962918508E+01 -1.90925675158E+01 -1.90886236360E+01 -1.90844606915E+01 -1.90800792634E+01 -1.90754800232E+01 -1.90706637227E+01 -1.90656311820E+01 -1.90603832784E+01 -1.90549209338E+01 -1.90492451021E+01 -1.90433567570E+01 -1.90372568780E+01 -1.90309464378E+01 -1.90244263881E+01 -1.90176976460E+01 -1.90107610808E+01 -1.90036174993E+01 -1.89962676325E+01 -1.89887121216E+01 -1.89809515046E+01 -1.89729862027E+01 -1.89648165070E+01 -1.89564425656E+01 -1.89478643707E+01 -1.89390817469E+01 -1.89300943384E+01 -1.89209015983E+01 -1.89115027772E+01 -1.89018969130E+01 -1.88920828204E+01 -1.88820590823E+01 -1.88718240404E+01 -1.88613757873E+01 -1.88507121587E+01 -1.88398307268E+01 -1.88287287938E+01 -1.88174033863E+01 -1.88058512500E+01 -1.87940688459E+01 -1.87820523458E+01 -1.87697976295E+01 -1.87573002820E+01 -1.87445555914E+01 -1.87315585470E+01 -1.87183038387E+01 -1.87047858553E+01 -1.86909986849E+01 -1.86769361140E+01 -1.86625916280E+01 -1.86479584112E+01 -1.86330293469E+01 -1.86177970179E+01 -1.86022537063E+01 -1.85863913936E+01 -1.85702017601E+01 -1.85536761845E+01 -1.85368057421E+01 -1.85195812031E+01 -1.85019930298E+01 -1.84840313731E+01 -1.84656860675E+01 -1.84469466258E+01 -1.84278022317E+01 -1.84082417314E+01 -1.83882536233E+01 -1.83678260464E+01 -1.83469467664E+01 -1.83256031598E+01 -1.83037821958E+01 -1.82814704163E+01 -1.82586539122E+01 -1.82353182981E+01 -1.82114486836E+01 -1.81870296414E+01 -1.81620451725E+01 -1.81364786674E+01 -1.81103128644E+01 -1.80835298032E+01 -1.80561107753E+01 -1.80280362698E+01 -1.79992859144E+01 -1.79698384128E+01 -1.79396714766E+01 -1.79087617523E+01 -1.78770847436E+01 -1.78446147284E+01 -1.78113246701E+01 -1.77771861244E+01 -1.77421691398E+01 -1.77062421538E+01 -1.76693718831E+01 -1.76315232103E+01 -1.75926590646E+01 -1.75527403004E+01 -1.75117255719E+01 -1.74695712058E+01 -1.74262310745E+01 -1.73816564683E+01 -1.73357959726E+01 -1.72885953485E+01 -1.72399974225E+01 -1.71899419863E+01 -1.71383657117E+01 -1.70852020833E+01 -1.70303813547E+01 -1.69738305310E+01 -1.69154733845E+01 -1.68552305078E+01 -1.67930194085E+01 -1.67287546529E+01 -1.66623480609E+01 -1.65937089583E+01 -1.65227444886E+01 -1.64493599878E+01 -1.63734594232E+01 -1.62949458949E+01 -1.62137222007E+01 -1.61296914584E+01 -1.60427577806E+01 -1.59528269964E+01 -1.58598074083E+01 -1.57636105760E+01 -1.56641521144E+01 -1.55613524932E+01 -1.54551378254E+01 -1.53454406328E+01 -1.52322005752E+01 -1.51153651348E+01 -1.49948902451E+01 -1.48707408603E+01 -1.47428914600E+01 -1.46113264887E+01 -1.44760407323E+01 -1.43370396353E+01 -1.41943395666E+01 -1.40479680408E+01 -1.38979639057E+01 -1.37443775065E+01 -1.35872708368E+01 -1.34267176851E+01 -1.32628037879E+01 -1.30956269941E+01 -1.29252974463E+01 -1.27519377831E+01 -1.25756833598E+01 -1.23966824893E+01 -1.22150966952E+01 -1.20311009726E+01 -1.18448840482E+01 -1.16566486278E+01 -1.14666116212E+01 -1.12750043309E+01 -1.10820725913E+01 -1.08880768425E+01 -1.06932921263E+01 -1.04980079860E+01 -1.03025282569E+01 -1.01071707296E+01 -9.91226667060E+00 -9.71816018432E+00 -9.52520739767E+00 -9.33377545164E+00 -9.14424128079E+00 -8.95699016243E+00 -8.77241401623E+00 -8.59090943453E+00 -8.41287542328E+00 -8.23871083316E+00 -8.06881146101E+00 -7.90356680213E+00 -7.74335643569E+00 -7.58854602786E+00 -7.43948294081E+00 -7.29649144056E+00 -7.15986750334E+00 -7.02987322866E+00 -6.90673087809E+00 -6.79061657274E+00 -6.68165369942E+00 -6.57990609703E+00 -6.48537112113E+00 -6.39797271700E+00 -6.31755467183E+00 -6.24387426494E+00 -6.17659659436E+00 -6.11528992893E+00 -6.05942252035E+00 -6.00836140978E+00 -5.96137388167E+00 -5.91763235405E+00 -5.87622365160E+00 -5.83616378695E+00 -5.79641957807E+00 -5.75593865720E+00 -5.71368968291E+00 -5.66871485458E+00 -5.62019715471E+00 -5.56754511764E+00 -5.51049835645E+00 -5.44925758928E+00 -5.38464337604E+00 -5.31828681597E+00 -5.25225705254E+00 -5.18704140776E+00 -5.12263212541E+00 -5.05901971113E+00 -4.99619463539E+00 -4.93414745143E+00 -4.87286879672E+00 -4.81234939436E+00 -4.75258005449E+00 -4.69355167553E+00 -4.63525524534E+00 -4.57768184222E+00 -4.52082263581E+00 -4.46466888781E+00 -4.40921195261E+00 -4.35444327771E+00 -4.30035440408E+00 -4.24693696634E+00 -4.19418269298E+00 -4.14208340590E+00 -4.09063102042E+00 -4.03981754584E+00 -3.98963508427E+00 -3.94007583018E+00 -3.89113207017E+00 -3.84279618236E+00 -3.79506063623E+00 -3.74791799149E+00 -3.70136089733E+00 -3.65538209194E+00 -3.60997440166E+00 -3.56513074020E+00 -3.52084410778E+00 -3.47710759031E+00 -3.43391435852E+00 -3.39125766709E+00 -3.34913085376E+00 -3.30752733842E+00 -3.26644062222E+00 -3.22586428665E+00 -3.18579199263E+00 -3.14621747961E+00 -3.10713456461E+00 -3.06853714134E+00 -3.03041917929E+00 -2.99277472280E+00 -2.95559789017E+00 -2.91888287273E+00 -2.88262393400E+00 -2.84681540873E+00 -2.81145170208E+00 -2.77652728872E+00 -2.74203671196E+00 -2.70797458291E+00 -2.67433557963E+00 -2.64111444626E+00 -2.60830599226E+00 -2.57590509153E+00 -2.54390668166E+00 -2.51230576306E+00 -2.48109739826E+00 -2.45027671108E+00 -2.41983888587E+00 -2.38977916680E+00 -2.36009285704E+00 -2.33077531811E+00 -2.30182196904E+00 -2.27322828592E+00 -2.24498980096E+00 -2.21710210144E+00 -2.18956082987E+00 -2.16236168293E+00 -2.13550041045E+00 -2.10897281517E+00 -2.08277475195E+00 -2.05690212712E+00 -2.03135089788E+00 -2.00611707163E+00 -1.98119670538E+00 -1.95658590513E+00 -1.93228082524E+00 -1.90827766785E+00 -1.88457268231E+00 -1.86116216455E+00 -1.83804245652E+00 -1.81520994564E+00 -1.79266106419E+00 -1.77039228881E+00 -1.74840013989E+00 -1.72668118108E+00 -1.70523201871E+00 -1.68404930127E+00 -1.66312971892E+00 -1.64247000292E+00 -1.62206692515E+00 -1.60191729759E+00 -1.58201797183E+00 -1.56236583859E+00 -1.54295782721E+00 -1.52379090517E+00 -1.50486207763E+00 -1.48616838697E+00 -1.46770691228E+00 -1.44947476897E+00 -1.43146910826E+00 -1.41368711678E+00 -1.39612601608E+00 -1.37878306227E+00 -1.36165554550E+00 -1.34474078960E+00 -1.32803615165E+00 -1.31153902156E+00 -1.29524682164E+00 -1.27915700626E+00 -1.26326706137E+00 -1.24757450417E+00 -1.23207688271E+00 -1.21677177547E+00 -1.20165679104E+00 -1.18672956769E+00 -1.17198777304E+00 -1.15742910369E+00 -1.14305128483E+00 -1.12885206992E+00 -1.11482924034E+00 -1.10098060500E+00 -1.08730400004E+00 -1.07379728850E+00 -1.06045835992E+00 -1.04728513010E+00 -1.03427554071E+00 -1.02142755898E+00 -1.00873917741E+00 -9.96208413423E-01 -9.83833309072E-01 -9.71611930733E-01 -9.59542368802E-01 -9.47622737395E-01 -9.35851174055E-01 -9.24225839458E-01 -9.12744917130E-01 -9.01406613161E-01 -8.90209155924E-01 -8.79150795799E-01 -8.68229804901E-01 -8.57444476806E-01 -8.46793126291E-01 -8.36274089062E-01 -8.25885721503E-01 -8.15626400413E-01 -8.05494522754E-01 -7.95488505401E-01 -7.85606784895E-01 -7.75847817198E-01 -7.66210077453E-01 -7.56692059742E-01 -7.47292276855E-01 -7.38009260057E-01 -7.28841558856E-01 -7.19787740838E-01 -7.10846390683E-01 -7.02016115000E-01 -6.93295524499E-01 -6.84683227997E-01 -6.76177956338E-01 -6.67778338859E-01 -6.59483063104E-01 -6.51290832920E-01 -6.43200368254E-01 -6.35210404954E-01 -6.27319694572E-01 -6.19527004168E-01 -6.11831116120E-01 -6.04230827929E-01 -5.96724952033E-01 -5.89312315626E-01 -5.81991760467E-01 -5.74762142705E-01 -5.67622332697E-01 -5.60571214834E-01 -5.53607687363E-01 -5.46730662220E-01 -5.39939064856E-01 -5.33231834069E-01 -5.26607921841E-01 -5.20066293172E-01 -5.13605925920E-01 -5.07225810639E-01 -5.00924950423E-01 -4.94702360749E-01 -4.88557069326E-01 -4.82488115940E-01 -4.76494552303E-01 -4.70575441909E-01 -4.64729859886E-01 -4.58956892848E-01 -4.53255638759E-01 -4.47625206786E-01 -4.42064717163E-01 -4.36573301050E-01 -4.31150100405E-01 -4.25794267839E-01 -4.20504966495E-01 -4.15281369907E-01 -4.10122661878E-01 -4.05028036350E-01 -3.99996697276E-01 -3.95027858500E-01 -3.90120743630E-01 -3.85274585921E-01 -3.80488628150E-01 -3.75762122500E-01 -3.71094330447E-01 -3.66484522639E-01 -3.61931978782E-01 -3.57435987529E-01 -3.52995846382E-01 -3.48610861553E-01 -3.44280347881E-01 -3.40003628713E-01 -3.35780035805E-01 -3.31608909210E-01 -3.27489597182E-01 -3.23421456069E-01 -3.19403850217E-01 -3.15436151867E-01 -3.11517741057E-01 -3.07648005528E-01 -3.03826340626E-01 -3.00052149207E-01 -2.96324841547E-01 -2.92643835247E-01 -2.89008555141E-01 -2.85418433210E-01 -2.81872908490E-01 -2.78371426986E-01 -2.74913441583E-01 -2.71498411965E-01 -2.68125804526E-01 -2.64795092289E-01 -2.61505754824E-01 -2.58257278166E-01 -2.55049154733E-01 -2.51880883249E-01 -2.48751968665E-01 -2.45661922083E-01 -2.42610260676E-01 -2.39596507616E-01 -2.36620191997E-01 -2.33680848765E-01 -2.30778018641E-01 -2.27911248051E-01 -2.25080089058E-01 -2.22284099287E-01 -2.19522841859E-01 -2.16795885321E-01 -2.14102803582E-01 -2.11443175841E-01 -2.08816586526E-01 -2.06222625228E-01 -2.03660886635E-01 -2.01130970470E-01 -1.98632481428E-01 -1.96165029115E-01 -1.93728227987E-01 -1.91321697289E-01 -1.88945060996E-01 -1.86597947752E-01 -1.84279990818E-01 -1.81990828007E-01 -1.79730101633E-01 -1.77497458453E-01 -1.75292549613E-01 -1.73115030589E-01 -1.70964561142E-01 -1.68840805255E-01 -1.66743431087E-01 -1.64672110920E-01 -1.62626521105E-01 -1.60606342015E-01 -1.58611257992E-01 -1.56640957302E-01 -1.54695132079E-01 -1.52773478286E-01 -1.50875695659E-01 -1.49001487667E-01 -1.47150561461E-01 -1.45322627829E-01 -1.43517401153E-01 -1.41734599364E-01 -1.39973943893E-01 -1.38235159637E-01 -1.36517974905E-01 -1.34822121384E-01 -1.33147334095E-01 -1.31493351347E-01 -1.29859914703E-01 -1.28246768934E-01 -1.26653661985E-01 -1.25080344927E-01 -1.23526571928E-01 -1.21992100208E-01 -1.20476690001E-01 -1.18980104522E-01 -1.17502109926E-01 -1.16042475274E-01 -1.14600972495E-01 -1.13177376351E-01 -1.11771464403E-01 -1.10383016973E-01 -1.09011817114E-01 -1.07657650573E-01 -1.06320305759E-01 -1.04999573710E-01 -1.03695248057E-01 -1.02407124998E-01 -1.01135003260E-01 -9.98786840725E-02 -9.86379711326E-02 -9.74126705763E-02 -9.62025909480E-02 -9.50075431702E-02 -9.38273405143E-02 -9.26617985713E-02 -9.15107352229E-02 -9.03739706130E-02 -8.92513271199E-02 -8.81426293282E-02 -8.70477040017E-02 -8.59663800561E-02 -8.48984885322E-02 -8.38438625699E-02 -8.28023373817E-02 -8.17737502271E-02 -8.07579403874E-02 -7.97547491403E-02 1 0 Beta L 747 -1.51248818626E-03 -1.53151294580E-03 -1.55077700736E-03 -1.57028338099E-03 -1.59003511460E-03 -1.61003529445E-03 -1.63028704560E-03 -1.65079353242E-03 -1.67155795911E-03 -1.69258357014E-03 -1.71387365081E-03 -1.73543152773E-03 -1.75726056938E-03 -1.77936418658E-03 -1.80174583306E-03 -1.82440900602E-03 -1.84735724661E-03 -1.87059414054E-03 -1.89412331863E-03 -1.91794845736E-03 -1.94207327945E-03 -1.96650155447E-03 -1.99123709937E-03 -2.01628377914E-03 -2.04164550738E-03 -2.06732624690E-03 -2.09333001037E-03 -2.11966086094E-03 -2.14632291286E-03 -2.17332033213E-03 -2.20065733714E-03 -2.22833819937E-03 -2.25636724400E-03 -2.28474885064E-03 -2.31348745396E-03 -2.34258754443E-03 -2.37205366901E-03 -2.40189043183E-03 -2.43210249495E-03 -2.46269457908E-03 -2.49367146428E-03 -2.52503799076E-03 -2.55679905960E-03 -2.58895963354E-03 -2.62152473773E-03 -2.65449946055E-03 -2.68788895435E-03 -2.72169843632E-03 -2.75593318926E-03 -2.79059856242E-03 -2.82569997234E-03 -2.86124290368E-03 -2.89723291011E-03 -2.93367561514E-03 -2.97057671302E-03 -3.00794196961E-03 -3.04577722333E-03 -3.08408838601E-03 -3.12288144385E-03 -3.16216245834E-03 -3.20193756723E-03 -3.24221298547E-03 -3.28299500616E-03 -3.32429000160E-03 -3.36610442420E-03 -3.40844480757E-03 -3.45131776747E-03 -3.49473000290E-03 -3.53868829711E-03 -3.58319951868E-03 -3.62827062258E-03 -3.67390865127E-03 -3.72012073579E-03 -3.76691409687E-03 -3.81429604608E-03 -3.86227398694E-03 -3.91085541612E-03 -3.96004792457E-03 -4.00985919872E-03 -4.06029702169E-03 -4.11136927451E-03 -4.16308393731E-03 -4.21544909063E-03 -4.26847291664E-03 -4.32216370042E-03 -4.37652983128E-03 -4.43157980404E-03 -4.48732222039E-03 -4.54376579019E-03 -4.60091933287E-03 -4.65879177882E-03 -4.71739217071E-03 -4.77672966499E-03 -4.83681353328E-03 -4.89765316381E-03 -4.95925806291E-03 -5.02163785648E-03 -5.08480229150E-03 -5.14876123756E-03 -5.21352468839E-03 -5.27910276342E-03 -5.34550570936E-03 -5.41274390184E-03 -5.48082784696E-03 -5.54976818301E-03 -5.61957568206E-03 -5.69026125169E-03 -5.76183593669E-03 -5.83431092077E-03 -5.90769752829E-03 -5.98200722610E-03 -6.05725162526E-03 -6.13344248286E-03 -6.21059170392E-03 -6.28871134318E-03 -6.36781360701E-03 -6.44791085533E-03 -6.52901560351E-03 -6.61114052438E-03 -6.69429845013E-03 -6.77850237440E-03 -6.86376545425E-03 -6.95010101224E-03 -7.03752253850E-03 -7.12604369286E-03 -7.21567830696E-03 -7.30644038644E-03 -7.39834411308E-03 -7.49140384706E-03 -7.58563412921E-03 -7.68104968323E-03 -7.77766541805E-03 -7.87549643010E-03 -7.97455800573E-03 -8.07486562356E-03 -8.17643495691E-03 -8.27928187625E-03 -8.38342245166E-03 -8.48887295539E-03 -8.59564986433E-03 -8.70376986267E-03 -8.81324984443E-03 -8.92410691615E-03 -9.03635839954E-03 -9.15002183418E-03 -9.26511498030E-03 -9.38165582149E-03 -9.49966256760E-03 -9.61915365749E-03 -9.74014776196E-03 -9.86266378668E-03 -9.98672087513E-03 -1.01123384116E-02 -1.02395360241E-02 -1.03683335876E-02 -1.04987512272E-02 -1.06308093210E-02 -1.07645285034E-02 -1.08999296685E-02 -1.10370339730E-02 -1.11758628400E-02 -1.13164379618E-02 -1.14587813038E-02 -1.16029151075E-02 -1.17488618942E-02 -1.18966444686E-02 -1.20462859222E-02 -1.21978096369E-02 -1.23512392888E-02 -1.25065988517E-02 -1.26639126011E-02 -1.28232051178E-02 -1.29845012918E-02 -1.31478263260E-02 -1.33132057406E-02 -1.34806653767E-02 -1.36502314004E-02 -1.38219303070E-02 -1.39957889250E-02 -1.41718344205E-02 -1.43500943011E-02 -1.45305964207E-02 -1.47133689833E-02 -1.48984405479E-02 -1.50858400325E-02 -1.52755967190E-02 -1.54677402576E-02 -1.56623006715E-02 -1.58593083615E-02 -1.60587941109E-02 -1.62607890899E-02 -1.64653248613E-02 -1.66724333845E-02 -1.68821470212E-02 -1.70944985398E-02 -1.73095211213E-02 -1.75272483639E-02 -1.77477142883E-02 -1.79709533434E-02 -1.81970004113E-02 -1.84258908128E-02 -1.86576603131E-02 -1.88923451273E-02 -1.91299819259E-02 -1.93706078409E-02 -1.96142604713E-02 -1.98609778889E-02 -2.01107986446E-02 -2.03637617741E-02 -2.06199068043E-02 -2.08792737591E-02 -2.11419031661E-02 -2.14078360624E-02 -2.16771140015E-02 -2.19497790597E-02 -2.22258738423E-02 -2.25054414909E-02 -2.27885256893E-02 -2.30751706713E-02 -2.33654212269E-02 -2.36593227094E-02 -2.39569210429E-02 -2.42582627289E-02 -2.45633948541E-02 -2.48723650972E-02 -2.51852217371E-02 -2.55020136597E-02 -2.58227903658E-02 -2.61476019792E-02 -2.64764992540E-02 -2.68095335828E-02 -2.71467570046E-02 -2.74882222132E-02 -2.78339825652E-02 -2.81840920883E-02 -2.85386054899E-02 -2.88975781657E-02 -2.92610662081E-02 -2.96291264152E-02 -3.00018162996E-02 -3.03791940974E-02 -3.07613187771E-02 -3.11482500494E-02 -3.15400483759E-02 -3.19367749786E-02 -3.23384918501E-02 -3.27452617625E-02 -3.31571482778E-02 -3.35742157574E-02 -3.39965293726E-02 -3.44241551144E-02 -3.48571598039E-02 -3.52956111031E-02 -3.57395775248E-02 -3.61891284440E-02 -3.66443341085E-02 -3.71052656495E-02 -3.75719950933E-02 -3.80445953724E-02 -3.85231403366E-02 -3.90077047649E-02 -3.94983643770E-02 -3.99951958451E-02 -4.04982768063E-02 -4.10076858741E-02 -4.15235026511E-02 -4.20458077416E-02 -4.25746827635E-02 -4.31102103619E-02 -4.36524742217E-02 -4.42015590803E-02 -4.47575507414E-02 -4.53205360883E-02 -4.58906030971E-02 -4.64678408512E-02 -4.70523395543E-02 -4.76441905454E-02 -4.82434863124E-02 -4.88503205070E-02 -4.94647879591E-02 -5.00869846918E-02 -5.07170079363E-02 -5.13549561472E-02 -5.20009290178E-02 -5.26550274958E-02 -5.33173537991E-02 -5.39880114315E-02 -5.46671051994E-02 -5.53547412278E-02 -5.60510269769E-02 -5.67560712594E-02 -5.74699842568E-02 -5.81928775371E-02 -5.89248640722E-02 -5.96660582557E-02 -6.04165759203E-02 -6.11765343566E-02 -6.19460523308E-02 -6.27252501040E-02 -6.35142494502E-02 -6.43131736761E-02 -6.51221476400E-02 -6.59412977714E-02 -6.67707520909E-02 -6.76106402301E-02 -6.84610934520E-02 -6.93222446714E-02 -7.01942284761E-02 -7.10771811474E-02 -7.19712406818E-02 -7.28765468127E-02 -7.37932410319E-02 -7.47214666122E-02 -7.56613686294E-02 -7.66130939855E-02 -7.75767914312E-02 -7.85526115896E-02 -7.95407069796E-02 -8.05412320399E-02 -8.15543431530E-02 -8.25801986701E-02 -8.36189589353E-02 -8.46707863115E-02 -8.57358452050E-02 -8.68143020920E-02 -8.79063255443E-02 -8.90120862558E-02 -9.01317570692E-02 -9.12655130032E-02 -9.24135312801E-02 -9.35759913532E-02 -9.47530749352E-02 -9.59449660265E-02 -9.71518509444E-02 -9.83739183521E-02 -9.96113592882E-02 -1.00864367197E-01 -1.02133137958E-01 -1.03417869919E-01 -1.04718763922E-01 -1.06036023343E-01 -1.07369854116E-01 -1.08720464768E-01 -1.10088066455E-01 -1.11472872989E-01 -1.12875100879E-01 -1.14294969357E-01 -1.15732700418E-01 -1.17188518855E-01 -1.18662652290E-01 -1.20155331213E-01 -1.21666789019E-01 -1.23197262042E-01 -1.24746989593E-01 -1.26316214000E-01 -1.27905180642E-01 -1.29514137991E-01 -1.31143337651E-01 -1.32793034393E-01 -1.34463486201E-01 -1.36154954311E-01 -1.37867703249E-01 -1.39602000877E-01 -1.41358118431E-01 -1.43136330568E-01 -1.44936915405E-01 -1.46760154566E-01 -1.48606333226E-01 -1.50475740154E-01 -1.52368667760E-01 -1.54285412141E-01 -1.56226273128E-01 -1.58191554332E-01 -1.60181563195E-01 -1.62196611033E-01 -1.64237013090E-01 -1.66303088588E-01 -1.68395160773E-01 -1.70513556970E-01 -1.72658608633E-01 -1.74830651398E-01 -1.77030025137E-01 -1.79257074008E-01 -1.81512146516E-01 -1.83795595561E-01 -1.86107778498E-01 -1.88449057193E-01 -1.90819798081E-01 -1.93220372221E-01 -1.95651155358E-01 -1.98112527981E-01 -2.00604875385E-01 -2.03128587730E-01 -2.05684060104E-01 -2.08271692584E-01 -2.10891890304E-01 -2.13545063515E-01 -2.16231627650E-01 -2.18952003395E-01 -2.21706616750E-01 -2.24495899099E-01 -2.27320287282E-01 -2.30180223658E-01 -2.33076156181E-01 -2.36008538469E-01 -2.38977829876E-01 -2.41984495568E-01 -2.45029006592E-01 -2.48111839957E-01 -2.51233478705E-01 -2.54394411994E-01 -2.57595135169E-01 -2.60836149848E-01 -2.64117963997E-01 -2.67441092016E-01 -2.70806054816E-01 -2.74213379907E-01 -2.77663601482E-01 -2.81157260499E-01 -2.84694904772E-01 -2.88277089056E-01 -2.91904375139E-01 -2.95577331928E-01 -2.99296535546E-01 -3.03062569419E-01 -3.06876024373E-01 -3.10737498731E-01 -3.14647598403E-01 -3.18606936991E-01 -3.22616135882E-01 -3.26675824353E-01 -3.30786639667E-01 -3.34949227183E-01 -3.39164240453E-01 -3.43432341334E-01 -3.47754200089E-01 -3.52130495500E-01 -3.56561914977E-01 -3.61049154668E-01 -3.65592919570E-01 -3.70193923650E-01 -3.74852889952E-01 -3.79570550722E-01 -3.84347647522E-01 -3.89184931351E-01 -3.94083162770E-01 -3.99043112020E-01 -4.04065559153E-01 -4.09151294157E-01 -4.14301117081E-01 -4.19515838169E-01 -4.24796277992E-01 -4.30143267577E-01 -4.35557648549E-01 -4.41040273261E-01 -4.46592004938E-01 -4.52213717815E-01 -4.57906297279E-01 -4.63670640015E-01 -4.69507654150E-01 -4.75418259401E-01 -4.81403387227E-01 -4.87463980976E-01 -4.93600996043E-01 -4.99815400019E-01 -5.06108172858E-01 -5.12480307024E-01 -5.18932807663E-01 -5.25466692755E-01 -5.32082993290E-01 -5.38782753425E-01 -5.45567030657E-01 -5.52436895995E-01 -5.59393434129E-01 -5.66437743603E-01 -5.73570936999E-01 -5.80794141105E-01 -5.88108497102E-01 -5.95515160742E-01 -6.03015302536E-01 -6.10610107933E-01 -6.18300777513E-01 -6.26088527174E-01 -6.33974588319E-01 -6.41960208057E-01 -6.50046649387E-01 -6.58235191401E-01 -6.66527129478E-01 -6.74923775481E-01 -6.83426457961E-01 -6.92036522354E-01 -7.00755331185E-01 -7.09584264274E-01 -7.18524718934E-01 -7.27578110182E-01 -7.36745870943E-01 -7.46029452257E-01 -7.55430323485E-01 -7.64949972516E-01 -7.74589905976E-01 -7.84351649435E-01 -7.94236747612E-01 -8.04246764583E-01 -8.14383283986E-01 -8.24647909226E-01 -8.35042263677E-01 -8.45567990884E-01 -8.56226754762E-01 -8.67020239792E-01 -8.77950151218E-01 -8.89018215234E-01 -9.00226179174E-01 -9.11575811695E-01 -9.23068902952E-01 -9.34707264775E-01 -9.46492730833E-01 -9.58427156798E-01 -9.70512420494E-01 -9.82750422048E-01 -9.95143084020E-01 -1.00769235154E+00 -1.02040019240E+00 -1.03326859720E+00 -1.04629957941E+00 -1.05949517545E+00 -1.07285744477E+00 -1.08638846986E+00 -1.10009035635E+00 -1.11396523296E+00 -1.12801525149E+00 -1.14224258683E+00 -1.15664943689E+00 -1.17123802249E+00 -1.18601058728E+00 -1.20096939761E+00 -1.21611674231E+00 -1.23145493254E+00 -1.24698630152E+00 -1.26271320424E+00 -1.27863801715E+00 -1.29476313777E+00 -1.31109098429E+00 -1.32762399509E+00 -1.34436462818E+00 -1.36131536064E+00 -1.37847868797E+00 -1.39585712332E+00 -1.41345319673E+00 -1.43126945424E+00 -1.44930845691E+00 -1.46757277978E+00 -1.48606501072E+00 -1.50478774916E+00 -1.52374360475E+00 -1.54293519585E+00 -1.56236514793E+00 -1.58203609187E+00 -1.60195066202E+00 -1.62211149419E+00 -1.64252122348E+00 -1.66318248191E+00 -1.68409789582E+00 -1.70527008323E+00 -1.72670165080E+00 -1.74839519075E+00 -1.77035327740E+00 -1.79257846357E+00 -1.81507327666E+00 -1.83784021449E+00 -1.86088174082E+00 -1.88420028053E+00 -1.90779821457E+00 -1.93167787443E+00 -1.95584153633E+00 -1.98029141499E+00 -2.00502965694E+00 -2.03005833348E+00 -2.05537943307E+00 -2.08099485331E+00 -2.10690639232E+00 -2.13311573964E+00 -2.15962446648E+00 -2.18643401542E+00 -2.21354568937E+00 -2.24096063993E+00 -2.26867985497E+00 -2.29670414546E+00 -2.32503413147E+00 -2.35367022736E+00 -2.38261262603E+00 -2.41186128229E+00 -2.44141589511E+00 -2.47127588899E+00 -2.50144039410E+00 -2.53190822533E+00 -2.56267786014E+00 -2.59374741505E+00 -2.62511462095E+00 -2.65677679687E+00 -2.68873082237E+00 -2.72097310838E+00 -2.75349956645E+00 -2.78630557635E+00 -2.81938595188E+00 -2.85273490492E+00 -2.88634600759E+00 -2.92021215242E+00 -2.95432551048E+00 -2.98867748746E+00 -3.02325867749E+00 -3.05805881472E+00 -3.09306672257E+00 -3.12827026055E+00 -3.16365626863E+00 -3.19921050904E+00 -3.23491760544E+00 -3.27076097943E+00 -3.30672278442E+00 -3.34278383654E+00 -3.37892354299E+00 -3.41511982734E+00 -3.45134905210E+00 -3.48758593846E+00 -3.52380348310E+00 -3.55997287227E+00 -3.59606339311E+00 -3.63204234225E+00 -3.66787493189E+00 -3.70352419339E+00 -3.73895087856E+00 -3.77411335892E+00 -3.80896752301E+00 -3.84346667224E+00 -3.87756141537E+00 -3.91119956225E+00 -3.94432601708E+00 -3.97688267180E+00 -4.00880830018E+00 -4.04003845322E+00 -4.07050535674E+00 -4.10013781183E+00 -4.12886109931E+00 -4.15659688909E+00 -4.18326315569E+00 -4.20877410127E+00 -4.23304008756E+00 -4.25596757828E+00 -4.27745909387E+00 -4.29741318043E+00 -4.31572439497E+00 -4.33228330923E+00 -4.34697653464E+00 -4.35968677106E+00 -4.37029288216E+00 -4.37867000069E+00 -4.38468966682E+00 -4.38822000323E+00 -4.38912593069E+00 -4.38726942815E+00 -4.38250984140E+00 -4.37470424503E+00 -4.36370786182E+00 -4.34937454468E+00 -4.33155732572E+00 -4.31010903750E+00 -4.28488301130E+00 -4.25573385744E+00 -4.22251833229E+00 -4.18509629667E+00 -4.14333176993E+00 -4.09709408349E+00 -4.04625913732E+00 -3.99071076178E+00 -3.93034218673E+00 -3.86505761842E+00 -3.79477392363E+00 -3.71942241876E+00 -3.63895076004E+00 -3.55332492876E+00 -3.46253130309E+00 -3.36657880550E+00 -3.26550111175E+00 -3.15935890393E+00 -3.04824214664E+00 -2.93227236138E+00 -2.81160486969E+00 -2.68643097148E+00 -2.55698001992E+00 -2.42352134945E+00 -2.28636600853E+00 -2.14586824377E+00 -2.00242667712E+00 -1.85648511355E+00 -1.70853291236E+00 -1.55910485180E+00 -1.40878041450E+00 -1.25818241922E+00 -1.10797492505E+00 -9.58860335045E-01 -8.11575630586E-01 -6.66887672767E-01 -5.25587515939E-01 -3.88483689159E-01 -2.56394415443E-01 -1.30138755809E-01 -1.05266855759E-02 1.01651865819E-01 2.05638953011E-01 3.00721441985E-01 3.86244603973E-01 4.61626317080E-01 5.26371677883E-01 5.80087784175E-01 6.22498407223E-01 6.53458227727E-01 6.72966264342E-01 6.81178077285E-01 6.78416282102E-01 6.65178859656E-01 6.42144696979E-01 6.10175738539E-01 5.70315066772E-01 5.23780162068E-01 4.71950512725E-01 4.16348651246E-01 3.58613580944E-01 3.00465422247E-01 2.43659947884E-01 1.89931487564E-01 1.40922464713E-01 9.80975814573E-02 6.26403974163E-02 3.53297608894E-02 1.63932589923E-02 5.33457041256E-03 7.31344451872E-04 -4.63598847201E-14 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1.50 1.50 2S 1 Number of nonzero Dij 1 1 1.06488053237E+00 2S 0 2.00 Wavefunction 1.17461068605E-04 1.18938546978E-04 1.20434609742E-04 1.21949490660E-04 1.23483426434E-04 1.25036656746E-04 1.26609424290E-04 1.28201974816E-04 1.29814557162E-04 1.31447423297E-04 1.33100828361E-04 1.34775030701E-04 1.36470291914E-04 1.38186876890E-04 1.39925053847E-04 1.41685094380E-04 1.43467273498E-04 1.45271869671E-04 1.47099164870E-04 1.48949444615E-04 1.50822998014E-04 1.52720117816E-04 1.54641100448E-04 1.56586246068E-04 1.58555858609E-04 1.60550245828E-04 1.62569719350E-04 1.64614594724E-04 1.66685191465E-04 1.68781833109E-04 1.70904847259E-04 1.73054565641E-04 1.75231324154E-04 1.77435462919E-04 1.79667326340E-04 1.81927263147E-04 1.84215626463E-04 1.86532773847E-04 1.88879067360E-04 1.91254873614E-04 1.93660563834E-04 1.96096513914E-04 1.98563104477E-04 2.01060720932E-04 2.03589753537E-04 2.06150597459E-04 2.08743652835E-04 2.11369324835E-04 2.14028023726E-04 2.16720164935E-04 2.19446169116E-04 2.22206462211E-04 2.25001475522E-04 2.27831645777E-04 2.30697415195E-04 2.33599231559E-04 2.36537548283E-04 2.39512824486E-04 2.42525525060E-04 2.45576120748E-04 2.48665088210E-04 2.51792910105E-04 2.54960075161E-04 2.58167078254E-04 2.61414420486E-04 2.64702609260E-04 2.68032158363E-04 2.71403588045E-04 2.74817425097E-04 2.78274202941E-04 2.81774461703E-04 2.85318748308E-04 2.88907616558E-04 2.92541627221E-04 2.96221348119E-04 2.99947354216E-04 3.03720227708E-04 3.07540558116E-04 3.11408942374E-04 3.15325984926E-04 3.19292297817E-04 3.23308500794E-04 3.27375221395E-04 3.31493095056E-04 3.35662765203E-04 3.39884883355E-04 3.44160109229E-04 3.48489110837E-04 3.52872564595E-04 3.57311155428E-04 3.61805576876E-04 3.66356531200E-04 3.70964729499E-04 3.75630891813E-04 3.80355747240E-04 3.85140034050E-04 3.89984499798E-04 3.94889901442E-04 3.99857005463E-04 4.04886587981E-04 4.09979434880E-04 4.15136341929E-04 4.20358114907E-04 4.25645569726E-04 4.30999532564E-04 4.36420839989E-04 4.41910339094E-04 4.47468887624E-04 4.53097354116E-04 4.58796618031E-04 4.64567569892E-04 4.70411111422E-04 4.76328155690E-04 4.82319627247E-04 4.88386462274E-04 4.94529608728E-04 5.00750026491E-04 5.07048687517E-04 5.13426575986E-04 5.19884688460E-04 5.26424034034E-04 5.33045634495E-04 5.39750524485E-04 5.46539751658E-04 5.53414376848E-04 5.60375474232E-04 5.67424131499E-04 5.74561450016E-04 5.81788545010E-04 5.89106545730E-04 5.96516595632E-04 6.04019852556E-04 6.11617488903E-04 6.19310691823E-04 6.27100663399E-04 6.34988620833E-04 6.42975796639E-04 6.51063438833E-04 6.59252811131E-04 6.67545193142E-04 6.75941880572E-04 6.84444185427E-04 6.93053436213E-04 7.01770978149E-04 7.10598173373E-04 7.19536401159E-04 7.28587058128E-04 7.37751558470E-04 7.47031334163E-04 7.56427835198E-04 7.65942529803E-04 7.75576904675E-04 7.85332465213E-04 7.95210735751E-04 8.05213259796E-04 8.15341600270E-04 8.25597339757E-04 8.35982080744E-04 8.46497445878E-04 8.57145078216E-04 8.67926641481E-04 8.78843820325E-04 8.89898320590E-04 9.01091869574E-04 9.12426216304E-04 9.23903131807E-04 9.35524409386E-04 9.47291864902E-04 9.59207337056E-04 9.71272687680E-04 9.83489802024E-04 9.95860589050E-04 1.00838698174E-03 1.02107093737E-03 1.03391443786E-03 1.04691949006E-03 1.06008812603E-03 1.07342240344E-03 1.08692440580E-03 1.10059624285E-03 1.11444005086E-03 1.12845799298E-03 1.14265225957E-03 1.15702506852E-03 1.17157866564E-03 1.18631532500E-03 1.20123734923E-03 1.21634706998E-03 1.23164684819E-03 1.24713907451E-03 1.26282616967E-03 1.27871058483E-03 1.29479480200E-03 1.31108133441E-03 1.32757272689E-03 1.34427155630E-03 1.36118043190E-03 1.37830199577E-03 1.39563892323E-03 1.41319392326E-03 1.43096973890E-03 1.44896914771E-03 1.46719496217E-03 1.48565003016E-03 1.50433723538E-03 1.52325949778E-03 1.54241977406E-03 1.56182105812E-03 1.58146638150E-03 1.60135881388E-03 1.62150146356E-03 1.64189747794E-03 1.66255004401E-03 1.68346238884E-03 1.70463778009E-03 1.72607952656E-03 1.74779097863E-03 1.76977552884E-03 1.79203661241E-03 1.81457770777E-03 1.83740233711E-03 1.86051406691E-03 1.88391650852E-03 1.90761331875E-03 1.93160820035E-03 1.95590490270E-03 1.98050722232E-03 2.00541900349E-03 2.03064413886E-03 2.05618657003E-03 2.08205028820E-03 2.10823933475E-03 2.13475780194E-03 2.16160983347E-03 2.18879962519E-03 2.21633142572E-03 2.24420953713E-03 2.27243831559E-03 2.30102217211E-03 2.32996557316E-03 2.35927304139E-03 2.38894915635E-03 2.41899855523E-03 2.44942593351E-03 2.48023604576E-03 2.51143370636E-03 2.54302379026E-03 2.57501123372E-03 2.60740103511E-03 2.64019825568E-03 2.67340802035E-03 2.70703551850E-03 2.74108600481E-03 2.77556480005E-03 2.81047729195E-03 2.84582893598E-03 2.88162525627E-03 2.91787184645E-03 2.95457437050E-03 2.99173856366E-03 3.02937023333E-03 3.06747525996E-03 3.10605959800E-03 3.14512927678E-03 3.18469040151E-03 3.22474915418E-03 3.26531179459E-03 3.30638466127E-03 3.34797417249E-03 3.39008682729E-03 3.43272920645E-03 3.47590797356E-03 3.51962987604E-03 3.56390174621E-03 3.60873050233E-03 3.65412314971E-03 3.70008678181E-03 3.74662858132E-03 3.79375582131E-03 3.84147586635E-03 3.88979617367E-03 3.93872429433E-03 3.98826787440E-03 4.03843465614E-03 4.08923247924E-03 4.14066928202E-03 4.19275310268E-03 4.24549208057E-03 4.29889445745E-03 4.35296857878E-03 4.40772289502E-03 4.46316596298E-03 4.51930644713E-03 4.57615312095E-03 4.63371486836E-03 4.69200068502E-03 4.75101967981E-03 4.81078107624E-03 4.87129421387E-03 4.93256854979E-03 4.99461366010E-03 5.05743924140E-03 5.12105511233E-03 5.18547121507E-03 5.25069761693E-03 5.31674451191E-03 5.38362222231E-03 5.45134120031E-03 5.51991202966E-03 5.58934542730E-03 5.65965224503E-03 5.73084347125E-03 5.80293023266E-03 5.87592379597E-03 5.94983556973E-03 6.02467710607E-03 6.10046010251E-03 6.17719640383E-03 6.25489800387E-03 6.33357704746E-03 6.41324583230E-03 6.49391681088E-03 6.57560259245E-03 6.65831594499E-03 6.74206979719E-03 6.82687724053E-03 6.91275153125E-03 6.99970609252E-03 7.08775451647E-03 7.17691056636E-03 7.26718817874E-03 7.35860146561E-03 7.45116471667E-03 7.54489240150E-03 7.63979917192E-03 7.73589986420E-03 7.83320950144E-03 7.93174329593E-03 8.03151665149E-03 8.13254516595E-03 8.23484463354E-03 8.33843104743E-03 8.44332060218E-03 8.54952969631E-03 8.65707493491E-03 8.76597313219E-03 8.87624131413E-03 8.98789672122E-03 9.10095681108E-03 9.21543926126E-03 9.33136197200E-03 9.44874306905E-03 9.56760090651E-03 9.68795406973E-03 9.80982137823E-03 9.93322188864E-03 1.00581748977E-02 1.01846999454E-02 1.03128168179E-02 1.04425455506E-02 1.05739064317E-02 1.07069200048E-02 1.08416070725E-02 1.09779886999E-02 1.11160862171E-02 1.12559212237E-02 1.13975155910E-02 1.15408914666E-02 1.16860712770E-02 1.18330777315E-02 1.19819338259E-02 1.21326628459E-02 1.22852883709E-02 1.24398342776E-02 1.25963247440E-02 1.27547842531E-02 1.29152375965E-02 1.30777098788E-02 1.32422265213E-02 1.34088132660E-02 1.35774961798E-02 1.37483016585E-02 1.39212564311E-02 1.40963875639E-02 1.42737224649E-02 1.44532888881E-02 1.46351149379E-02 1.48192290735E-02 1.50056601135E-02 1.51944372406E-02 1.53855900059E-02 1.55791483338E-02 1.57751425267E-02 1.59736032701E-02 1.61745616368E-02 1.63780490927E-02 1.65840975011E-02 1.67927391281E-02 1.70040066478E-02 1.72179331473E-02 1.74345521322E-02 1.76538975317E-02 1.78760037042E-02 1.81009054427E-02 1.83286379804E-02 1.85592369965E-02 1.87927386215E-02 1.90291794433E-02 1.92685965130E-02 1.95110273508E-02 1.97565099521E-02 2.00050827936E-02 2.02567848391E-02 2.05116555466E-02 2.07697348736E-02 2.10310632844E-02 2.12956817562E-02 2.15636317857E-02 2.18349553961E-02 2.21096951433E-02 2.23878941236E-02 2.26695959797E-02 2.29548449088E-02 2.32436856688E-02 2.35361635862E-02 2.38323245632E-02 2.41322150853E-02 2.44358822286E-02 2.47433736677E-02 2.50547376835E-02 2.53700231707E-02 2.56892796462E-02 2.60125572572E-02 2.63399067890E-02 2.66713796736E-02 2.70070279983E-02 2.73469045138E-02 2.76910626432E-02 2.80395564909E-02 2.83924408510E-02 2.87497712169E-02 2.91116037903E-02 2.94779954903E-02 2.98490039630E-02 3.02246875910E-02 3.06051055033E-02 3.09903175848E-02 3.13803844866E-02 3.17753676360E-02 3.21753292466E-02 3.25803323291E-02 3.29904407014E-02 3.34057189998E-02 3.38262326897E-02 3.42520480763E-02 3.46832323163E-02 3.51198534293E-02 3.55619803086E-02 3.60096827338E-02 3.64630313823E-02 3.69220978411E-02 3.73869546196E-02 3.78576751616E-02 3.83343338580E-02 3.88170060598E-02 3.93057680908E-02 3.98006972610E-02 4.03018718800E-02 4.08093712706E-02 4.13232757824E-02 4.18436668063E-02 4.23706267882E-02 4.29042392440E-02 4.34445887738E-02 4.39917610773E-02 4.45458429688E-02 4.51069223924E-02 4.56750884381E-02 4.62504313572E-02 4.68330425789E-02 4.74230147268E-02 4.80204416350E-02 4.86254183659E-02 4.92380412267E-02 4.98584077875E-02 5.04866168989E-02 5.11227687102E-02 5.17669646878E-02 5.24193076341E-02 5.30799017064E-02 5.37488524364E-02 5.44262667499E-02 5.51122529870E-02 5.58069209224E-02 5.65103817862E-02 5.72227482851E-02 5.79441346242E-02 5.86746565282E-02 5.94144312646E-02 6.01635776656E-02 6.09222161518E-02 6.16904687556E-02 6.24684591450E-02 6.32563126481E-02 6.40541562782E-02 6.48621187587E-02 6.56803305494E-02 6.65089238725E-02 6.73480327393E-02 6.81977929780E-02 6.90583422610E-02 6.99298201335E-02 7.08123680426E-02 7.17061293665E-02 7.26112494450E-02 7.35278756095E-02 7.44561572151E-02 7.53962456720E-02 7.63482944781E-02 7.73124592525E-02 7.82888977693E-02 7.92777699921E-02 8.02792381094E-02 8.12934665709E-02 8.23206221238E-02 8.33608738511E-02 8.44143932093E-02 8.54813540683E-02 8.65619327510E-02 8.76563080743E-02 8.87646613913E-02 8.98871766335E-02 9.10240403550E-02 9.21754417769E-02 9.33415728328E-02 9.45226282160E-02 9.57188054266E-02 9.69303048209E-02 9.81573296608E-02 9.94000861653E-02 1.00658783562E-01 1.01933634143E-01 1.03224853314E-01 1.04532659658E-01 1.05857274986E-01 1.07198924399E-01 1.08557836347E-01 1.09934242690E-01 1.11328378763E-01 1.12740483437E-01 1.14170799189E-01 1.15619572166E-01 1.17087052255E-01 1.18573493155E-01 1.20079152450E-01 1.21604291681E-01 1.23149176424E-01 1.24714076366E-01 1.26299265389E-01 1.27905021646E-01 1.29531627652E-01 1.31179370361E-01 1.32848541263E-01 1.34539436468E-01 1.36252356802E-01 1.37987607899E-01 1.39745500300E-01 1.41526349551E-01 1.43330476304E-01 1.45158206425E-01 1.47009871095E-01 1.48885806924E-01 1.50786356060E-01 1.52711866306E-01 1.54662691234E-01 1.56639190306E-01 1.58641728998E-01 1.60670678924E-01 1.62726417965E-01 1.64809330398E-01 1.66919807033E-01 1.69058245347E-01 1.71225049624E-01 1.73420631098E-01 1.75645408101E-01 1.77899806204E-01 1.80184258374E-01 1.82499205126E-01 1.84845094678E-01 1.87222383109E-01 1.89631534525E-01 1.92073021217E-01 1.94547323829E-01 1.97054931526E-01 1.99596342166E-01 2.02172062466E-01 2.04782608180E-01 2.07428504270E-01 2.10110285081E-01 2.12828494519E-01 2.15583686222E-01 2.18376423736E-01 2.21207280692E-01 2.24076840972E-01 2.26985698886E-01 2.29934459333E-01 2.32923737969E-01 2.35954161361E-01 2.39026367146E-01 2.42141004174E-01 2.45298732644E-01 2.48500224243E-01 2.51746162252E-01 2.55037241666E-01 2.58374169276E-01 2.61757663753E-01 2.65188455706E-01 2.68667287717E-01 2.72194914364E-01 2.75772102207E-01 2.79399629752E-01 2.83078287384E-01 2.86808877261E-01 2.90592213172E-01 2.94429120351E-01 2.98320435246E-01 3.02267005229E-01 3.06269688258E-01 3.10329352464E-01 3.14446875681E-01 3.18623144891E-01 3.22859055586E-01 3.27155511043E-01 3.31513421500E-01 3.35933703214E-01 3.40417277413E-01 3.44965069113E-01 3.49578005792E-01 3.54257015924E-01 3.59003027333E-01 3.63816965382E-01 3.68699750965E-01 3.73652298287E-01 3.78675512426E-01 3.83770286651E-01 3.88937499478E-01 3.94178011449E-01 3.99492661610E-01 4.04882263669E-01 4.10347601806E-01 4.15889426118E-01 4.21508447673E-01 4.27205333143E-01 4.32980698992E-01 4.38835105200E-01 4.44769048473E-01 4.50782954942E-01 4.56877172293E-01 4.63051961313E-01 4.69307486828E-01 4.75643807993E-01 4.82060867911E-01 4.88558482559E-01 4.95136328989E-01 5.01793932792E-01 5.08530654792E-01 5.15345676964E-01 5.22237987568E-01 5.29206365479E-01 5.36249363729E-01 5.43365292259E-01 5.50552199907E-01 5.57807855647E-01 5.65129729130E-01 5.72514970576E-01 5.79960390076E-01 5.87462436399E-01 5.95017175407E-01 6.02620268189E-01 6.10266949073E-01 6.17952003683E-01 6.25669747238E-01 6.33414003318E-01 6.41178083358E-01 6.48954767160E-01 6.56736284742E-01 6.64514299878E-01 6.72279895738E-01 6.80023563030E-01 6.87735191125E-01 6.95404062654E-01 7.03018852083E-01 7.10567628840E-01 7.18037865539E-01 7.25416451881E-01 7.32689714833E-01 7.39843445640E-01 7.46862934234E-01 7.53733011572E-01 7.60438100350E-01 7.66962274524E-01 7.73289327921E-01 7.79402852154E-01 7.85286323885E-01 7.90923201339E-01 7.96297029766E-01 8.01391555333E-01 8.06190846694E-01 8.10679423208E-01 8.14842388496E-01 8.18665567705E-01 8.22135646565E-01 8.25240309956E-01 8.27968377421E-01 8.30309932736E-01 8.32256444371E-01 8.33800873436E-01 8.34937765511E-01 8.35663322636E-01 8.35975451731E-01 8.35873785748E-01 8.35359674110E-01 8.34436139341E-01 8.33107797343E-01 8.31380739567E-01 8.29262376368E-01 8.26761242185E-01 8.23886764918E-01 8.20649004088E-01 8.17058365052E-01 8.13125299943E-01 8.08860010196E-01 8.04272170584E-01 7.99370700989E-01 7.94163619670E-01 7.88658020984E-01 7.82860231445E-01 7.76776196892E-01 7.70411984290E-01 7.63773933808E-01 7.56868662606E-01 7.49703056848E-01 7.42284263288E-01 7.34619680421E-01 7.26716949219E-01 7.18583943439E-01 7.10228759530E-01 7.01659706113E-01 6.92885293073E-01 6.83914220236E-01 6.74755365648E-01 6.65417773465E-01 6.55910641437E-01 6.46243308014E-01 6.36425239059E-01 6.26466014189E-01 6.16375312735E-01 6.06162899352E-01 5.95838609273E-01 5.85412333224E-01 5.74894002040E-01 5.64293570978E-01 5.53621003773E-01 5.42886256470E-01 5.32099261062E-01 5.21269908997E-01 5.10408034580E-01 4.99523398360E-01 4.88625670536E-01 4.77724414464E-01 4.66829070343E-01 4.55948939148E-01 4.45093166887E-01 4.34270729276E-01 4.23490416907E-01 4.12760820981E-01 4.02090319700E-01 3.91487065386E-01 3.80958972388E-01 3.70513705851E-01 3.60158671400E-01 3.49901005782E-01 3.39747568498E-01 3.29704934469E-01 3.19779387733E-01 3.09976916185E-01 3.00303207368E-01 2.90763645276E-01 2.81363308163E-01 2.72106967315E-01 2.62999086744E-01 2.54043823756E-01 2.45245030335E-01 2.36606255278E-01 2.28130747022E-01 2.19821457092E-01 2.11681044102E-01 2.03711878239E-01 1.95916046154E-01 1.88295356218E-01 1.80851344048E-01 1.73585278272E-01 1.66498166473E-01 1.59590761254E-01 1.52863566407E-01 1.46316843132E-01 1.39950616297E-01 1.33764680713E-01 1.27758607422E-01 1.21931749981E-01 1.16283250762E-01 1.10812047271E-01 1.05516878490E-01 1.00396291281E-01 9.54486468500E-02 9.06721273106E-02 8.60647423631E-02 8.16243361118E-02 7.73485940437E-02 7.32350501862E-02 6.92810944592E-02 6.54839802334E-02 6.18408321000E-02 5.83486538553E-02 5.50043366956E-02 5.18046676129E-02 4.87463379791E-02 4.58259522975E-02 4.30400370998E-02 4.03850499598E-02 3.78573885925E-02 3.54534000044E-02 3.31693896582E-02 3.10016306129E-02 2.89463726007E-02 2.69998509997E-02 2.51582956622E-02 2.34179395620E-02 2.17750272191E-02 2.02258228688E-02 1.87666183401E-02 1.73937406115E-02 1.61035590163E-02 1.48924920717E-02 1.37570139081E-02 1.26936602816E-02 1.16990341512E-02 1.07698108104E-02 9.90274256374E-03 9.09466294084E-03 8.34249044792E-03 7.64323185540E-03 6.99398502578E-03 6.39194128789E-03 5.83438736632E-03 5.31870687713E-03 4.84238140317E-03 4.40299116435E-03 3.99821529991E-03 3.62583178103E-03 3.28371697394E-03 2.96984487409E-03 2.68228603338E-03 2.41920620281E-03 2.17886471333E-03 1.95961261821E-03 1.75989062004E-03 1.57822680543E-03 1.41323421051E-03 1.26360823952E-03 1.12812395858E-03 1.00563328590E-03 8.95062099040E-04 7.95407278851E-04 7.05733708958E-04 6.25171248443E-04 5.52911694494E-04 4.88205750551E-04 4.30360014402E-04 3.78733999490E-04 3.32737201503E-04 2.91826221158E-04 2.55501952909E-04 2.23306848139E-04 1.94822260296E-04 1.69665878296E-04 1.47489253483E-04 1.27975424425E-04 1.10836642825E-04 9.58122029620E-05 8.26663761737E-05 7.11864511449E-05 6.11808799930E-05 5.24775294948E-05 4.49220361830E-05 3.83762634965E-05 3.27168586883E-05 2.78339067696E-05 2.36296784086E-05 2.00174683931E-05 1.69205673603E-05 1.42716360363E-05 1.20108856928E-05 1.00857147262E-05 8.44999575004E-06 7.06337237273E-06 5.89061985791E-06 4.90106541466E-06 4.06806396741E-06 3.36852537607E-06 2.78248921564E-06 2.29274337703E-06 1.88448291564E-06 1.54500574670E-06 1.26344196657E-06 1.03051376223E-06 8.38323056814E-07 6.80164224623E-07 5.50359392581E-07 4.44114025734E-07 3.57390670388E-07 2.86798898762E-07 2.29499662869E-07 1.83122421773E-07 1.45693554986E-07 1.15574715062E-07 9.14099042104E-08 7.20801827999E-08 5.66650319760E-08 4.44094983319E-08 3.46963458480E-08 2.70225293759E-08 2.09793851296E-08 1.62360073040E-08 1.25253464953E-08 9.63262547981E-09 7.38572159177E-09 5.64721291632E-09 4.30782828468E-09 3.28107916185E-09 2.49888550365E-09 1.89638200433E-09 1.43395528908E-09 1.08032882714E-09 8.10899241027E-10 6.06384582416E-10 4.51730311853E-10 3.35227302881E-10 2.47803581317E-10 1.82457842744E-10 1.33808191755E-10 9.77341304124E-11 7.10936958433E-11 5.15009027515E-11 3.71513710371E-11 2.66862875301E-11 1.90867311843E-11 1.35919419334E-11 9.63638632404E-12 6.80151272265E-12 4.77893391705E-12 3.34245835347E-12 2.32694122306E-12 1.61236698286E-12 1.11192572894E-12 7.63123919224E-13 5.21189229901E-13 3.54201359711E-13 2.39514852882E-13 1.61144238189E-13 1.07862267305E-13 7.18238562933E-14 4.75755623011E-14 3.13463116406E-14 2.05422106370E-14 1.33886462030E-14 8.67810859538E-15 5.59348167523E-15 3.58490374571E-15 2.28444102909E-15 1.44729885498E-15 9.11550110562E-16 5.70709088627E-16 3.55163547187E-16 2.19678912945E-16 1.35039669643E-16 8.24923304855E-17 5.00738246749E-17 3.02007887545E-17 1.80967691030E-17 1.07726738312E-17 6.37015063727E-18 3.74147793229E-18 2.18256445132E-18 1.26439862767E-18 7.27371330484E-19 4.15475355035E-19 2.35620188560E-19 1.32653466813E-19 7.41350901395E-20 4.11232928062E-20 2.26396662689E-20 1.23688394675E-20 6.70537200349E-21 3.60669538716E-21 1.92462381479E-21 1.01879932898E-21 5.34926242174E-22 2.78558950861E-22 1.43851115917E-22 7.36608338577E-23 3.73973739094E-23 1.88226116941E-23 9.39086488825E-24 4.64376539162E-24 2.27575419134E-24 1.10515109018E-24 5.31752315514E-25 2.53476748994E-25 1.19689710211E-25 5.59775326424E-26 2.59272579283E-26 1.18913816084E-26 5.39991920586E-27 2.42754380246E-27 1.08023121395E-27 4.75751841720E-28 2.07348986097E-28 8.94177833716E-29 3.81494757343E-29 1.61004256075E-29 6.72064456720E-30 2.77427316793E-30 1.13237798398E-30 4.56957624547E-31 1.82280576613E-31 7.18657014073E-32 2.79998569996E-32 1.07789903724E-32 4.09942478561E-33 1.54001143734E-33 5.71365399893E-34 2.09326799114E-34 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 3S 0 0.00 Wavefunction 3.89540143317E-05 3.94439955131E-05 3.99401398990E-05 4.04425250131E-05 4.09512293539E-05 4.14663324077E-05 4.19879146602E-05 4.25160576099E-05 4.30508437800E-05 4.35923567320E-05 4.41406810784E-05 4.46959024961E-05 4.52581077394E-05 4.58273846542E-05 4.64038221910E-05 4.69875104194E-05 4.75785405420E-05 4.81770049082E-05 4.87829970295E-05 4.93966115933E-05 5.00179444781E-05 5.06470927685E-05 5.12841547702E-05 5.19292300254E-05 5.25824193284E-05 5.32438247413E-05 5.39135496102E-05 5.45916985809E-05 5.52783776155E-05 5.59736940091E-05 5.66777564062E-05 5.73906748181E-05 5.81125606396E-05 5.88435266669E-05 5.95836871149E-05 6.03331576353E-05 6.10920553343E-05 6.18604987911E-05 6.26386080767E-05 6.34265047722E-05 6.42243119881E-05 6.50321543834E-05 6.58501581851E-05 6.66784512079E-05 6.75171628743E-05 6.83664242348E-05 6.92263679881E-05 7.00971285021E-05 7.09788418351E-05 7.18716457565E-05 7.27756797686E-05 7.36910851288E-05 7.46180048709E-05 7.55565838279E-05 7.65069686549E-05 7.74693078513E-05 7.84437517846E-05 7.94304527136E-05 8.04295648124E-05 8.14412441943E-05 8.24656489362E-05 8.35029391034E-05 8.45532767747E-05 8.56168260674E-05 8.66937531632E-05 8.77842263343E-05 8.88884159692E-05 9.00064945999E-05 9.11386369284E-05 9.22850198542E-05 9.34458225020E-05 9.46212262496E-05 9.58114147561E-05 9.70165739910E-05 9.82368922628E-05 9.94725602488E-05 1.00723771025E-04 1.01990720094E-04 1.03273605421E-04 1.04572627459E-04 1.05887989183E-04 1.07219896120E-04 1.08568556384E-04 1.09934180705E-04 1.11316982466E-04 1.12717177731E-04 1.14134985285E-04 1.15570626662E-04 1.17024326184E-04 1.18496310995E-04 1.19986811096E-04 1.21496059380E-04 1.23024291670E-04 1.24571746755E-04 1.26138666429E-04 1.27725295526E-04 1.29331881960E-04 1.30958676764E-04 1.32605934126E-04 1.34273911436E-04 1.35962869317E-04 1.37673071672E-04 1.39404785725E-04 1.41158282058E-04 1.42933834660E-04 1.44731720964E-04 1.46552221894E-04 1.48395621906E-04 1.50262209035E-04 1.52152274939E-04 1.54066114946E-04 1.56004028096E-04 1.57966317192E-04 1.59953288846E-04 1.61965253526E-04 1.64002525606E-04 1.66065423414E-04 1.68154269281E-04 1.70269389594E-04 1.72411114845E-04 1.74579779683E-04 1.76775722965E-04 1.78999287814E-04 1.81250821664E-04 1.83530676323E-04 1.85839208023E-04 1.88176777476E-04 1.90543749932E-04 1.92940495237E-04 1.95367387884E-04 1.97824807083E-04 2.00313136809E-04 2.02832765869E-04 2.05384087961E-04 2.07967501732E-04 2.10583410848E-04 2.13232224048E-04 2.15914355216E-04 2.18630223440E-04 2.21380253079E-04 2.24164873832E-04 2.26984520801E-04 2.29839634561E-04 2.32730661230E-04 2.35658052536E-04 2.38622265891E-04 2.41623764458E-04 2.44663017228E-04 2.47740499090E-04 2.50856690906E-04 2.54012079589E-04 2.57207158174E-04 2.60442425897E-04 2.63718388278E-04 2.67035557190E-04 2.70394450948E-04 2.73795594387E-04 2.77239518941E-04 2.80726762731E-04 2.84257870646E-04 2.87833394428E-04 2.91453892759E-04 2.95119931351E-04 2.98832083029E-04 3.02590927824E-04 3.06397053063E-04 3.10251053460E-04 3.14153531212E-04 3.18105096087E-04 3.22106365526E-04 3.26157964736E-04 3.30260526785E-04 3.34414692709E-04 3.38621111603E-04 3.42880440729E-04 3.47193345616E-04 3.51560500163E-04 3.55982586747E-04 3.60460296328E-04 3.64994328557E-04 3.69585391885E-04 3.74234203675E-04 3.78941490313E-04 3.83707987322E-04 3.88534439476E-04 3.93421600918E-04 3.98370235277E-04 4.03381115787E-04 4.08455025406E-04 4.13592756945E-04 4.18795113183E-04 4.24062906998E-04 4.29396961495E-04 4.34798110128E-04 4.40267196839E-04 4.45805076183E-04 4.51412613463E-04 4.57090684870E-04 4.62840177612E-04 4.68661990059E-04 4.74557031880E-04 4.80526224187E-04 4.86570499678E-04 4.92690802783E-04 4.98888089810E-04 5.05163329098E-04 5.11517501165E-04 5.17951598863E-04 5.24466627532E-04 5.31063605157E-04 5.37743562528E-04 5.44507543403E-04 5.51356604665E-04 5.58291816494E-04 5.65314262530E-04 5.72425040043E-04 5.79625260105E-04 5.86916047765E-04 5.94298542222E-04 6.01773897004E-04 6.09343280150E-04 6.17007874390E-04 6.24768877332E-04 6.32627501646E-04 6.40584975256E-04 6.48642541534E-04 6.56801459489E-04 6.65063003966E-04 6.73428465848E-04 6.81899152252E-04 6.90476386740E-04 6.99161509520E-04 7.07955877658E-04 7.16860865291E-04 7.25877863837E-04 7.35008282221E-04 7.44253547086E-04 7.53615103021E-04 7.63094412787E-04 7.72692957542E-04 7.82412237076E-04 7.92253770043E-04 8.02219094201E-04 8.12309766649E-04 8.22527364072E-04 8.32873482987E-04 8.43349739993E-04 8.53957772024E-04 8.64699236604E-04 8.75575812103E-04 8.86589198005E-04 8.97741115172E-04 9.09033306107E-04 9.20467535237E-04 9.32045589176E-04 9.43769277017E-04 9.55640430604E-04 9.67660904824E-04 9.79832577896E-04 9.92157351664E-04 1.00463715189E-03 1.01727392857E-03 1.03006965622E-03 1.04302633418E-03 1.05614598697E-03 1.06943066454E-03 1.08288244265E-03 1.09650342316E-03 1.11029573436E-03 1.12426153133E-03 1.13840299625E-03 1.15272233873E-03 1.16722179620E-03 1.18190363421E-03 1.19677014683E-03 1.21182365697E-03 1.22706651676E-03 1.24250110792E-03 1.25812984212E-03 1.27395516138E-03 1.28997953842E-03 1.30620547707E-03 1.32263551266E-03 1.33927221240E-03 1.35611817580E-03 1.37317603505E-03 1.39044845547E-03 1.40793813590E-03 1.42564780911E-03 1.44358024227E-03 1.46173823734E-03 1.48012463153E-03 1.49874229772E-03 1.51759414495E-03 1.53668311884E-03 1.55601220207E-03 1.57558441481E-03 1.59540281525E-03 1.61547050003E-03 1.63579060474E-03 1.65636630442E-03 1.67720081404E-03 1.69829738900E-03 1.71965932567E-03 1.74128996186E-03 1.76319267738E-03 1.78537089453E-03 1.80782807868E-03 1.83056773878E-03 1.85359342791E-03 1.87690874386E-03 1.90051732964E-03 1.92442287412E-03 1.94862911253E-03 1.97313982713E-03 1.99795884771E-03 2.02309005225E-03 2.04853736752E-03 2.07430476965E-03 2.10039628482E-03 2.12681598982E-03 2.15356801273E-03 2.18065653356E-03 2.20808578489E-03 2.23586005253E-03 2.26398367622E-03 2.29246105025E-03 2.32129662423E-03 2.35049490368E-03 2.38006045085E-03 2.40999788532E-03 2.44031188481E-03 2.47100718586E-03 2.50208858460E-03 2.53356093747E-03 2.56542916200E-03 2.59769823759E-03 2.63037320623E-03 2.66345917337E-03 2.69696130865E-03 2.73088484674E-03 2.76523508816E-03 2.80001740008E-03 2.83523721720E-03 2.87090004255E-03 2.90701144841E-03 2.94357707711E-03 2.98060264197E-03 3.01809392818E-03 3.05605679366E-03 3.09449717005E-03 3.13342106357E-03 3.17283455599E-03 3.21274380558E-03 3.25315504805E-03 3.29407459757E-03 3.33550884769E-03 3.37746427242E-03 3.41994742715E-03 3.46296494976E-03 3.50652356159E-03 3.55063006853E-03 3.59529136208E-03 3.64051442039E-03 3.68630630941E-03 3.73267418393E-03 3.77962528876E-03 3.82716695980E-03 3.87530662524E-03 3.92405180668E-03 3.97341012034E-03 4.02338927820E-03 4.07399708926E-03 4.12524146073E-03 4.17713039926E-03 4.22967201223E-03 4.28287450894E-03 4.33674620198E-03 4.39129550846E-03 4.44653095137E-03 4.50246116089E-03 4.55909487573E-03 4.61644094451E-03 4.67450832713E-03 4.73330609620E-03 4.79284343842E-03 4.85312965601E-03 4.91417416821E-03 4.97598651270E-03 5.03857634712E-03 5.10195345057E-03 5.16612772514E-03 5.23110919743E-03 5.29690802017E-03 5.36353447376E-03 5.43099896786E-03 5.49931204310E-03 5.56848437261E-03 5.63852676380E-03 5.70945015995E-03 5.78126564198E-03 5.85398443017E-03 5.92761788589E-03 6.00217751340E-03 6.07767496161E-03 6.15412202595E-03 6.23153065016E-03 6.30991292820E-03 6.38928110609E-03 6.46964758386E-03 6.55102491748E-03 6.63342582081E-03 6.71686316757E-03 6.80134999338E-03 6.88689949778E-03 6.97352504629E-03 7.06124017250E-03 7.15005858016E-03 7.23999414536E-03 7.33106091867E-03 7.42327312733E-03 7.51664517746E-03 7.61119165634E-03 7.70692733468E-03 7.80386716890E-03 7.90202630346E-03 8.00142007327E-03 8.10206400604E-03 8.20397382471E-03 8.30716544992E-03 8.41165500246E-03 8.51745880583E-03 8.62459338874E-03 8.73307548772E-03 8.84292204972E-03 8.95415023475E-03 9.06677741855E-03 9.18082119533E-03 9.29629938048E-03 9.41323001333E-03 9.53163136005E-03 9.65152191639E-03 9.77292041064E-03 9.89584580650E-03 1.00203173061E-02 1.01463543529E-02 1.02739766347E-02 1.04032040871E-02 1.05340568958E-02 1.06665555007E-02 1.08007205983E-02 1.09365731454E-02 1.10741343622E-02 1.12134257354E-02 1.13544690221E-02 1.14972862525E-02 1.16418997340E-02 1.17883320542E-02 1.19366060845E-02 1.20867449838E-02 1.22387722021E-02 1.23927114840E-02 1.25485868725E-02 1.27064227128E-02 1.28662436559E-02 1.30280746625E-02 1.31919410072E-02 1.33578682819E-02 1.35258824001E-02 1.36960096010E-02 1.38682764534E-02 1.40427098597E-02 1.42193370606E-02 1.43981856387E-02 1.45792835234E-02 1.47626589946E-02 1.49483406876E-02 1.51363575975E-02 1.53267390834E-02 1.55195148731E-02 1.57147150679E-02 1.59123701471E-02 1.61125109728E-02 1.63151687945E-02 1.65203752542E-02 1.67281623912E-02 1.69385626472E-02 1.71516088710E-02 1.73673343239E-02 1.75857726848E-02 1.78069580555E-02 1.80309249655E-02 1.82577083780E-02 1.84873436950E-02 1.87198667628E-02 1.89553138775E-02 1.91937217907E-02 1.94351277153E-02 1.96795693308E-02 1.99270847898E-02 2.01777127234E-02 2.04314922471E-02 2.06884629675E-02 2.09486649875E-02 2.12121389132E-02 2.14789258599E-02 2.17490674586E-02 2.20226058618E-02 2.22995837511E-02 2.25800443427E-02 2.28640313946E-02 2.31515892133E-02 2.34427626605E-02 2.37375971601E-02 2.40361387050E-02 2.43384338643E-02 2.46445297905E-02 2.49544742266E-02 2.52683155135E-02 2.55861025972E-02 2.59078850367E-02 2.62337130111E-02 2.65636373275E-02 2.68977094290E-02 2.72359814019E-02 2.75785059843E-02 2.79253365737E-02 2.82765272352E-02 2.86321327100E-02 2.89922084231E-02 2.93568104923E-02 2.97259957362E-02 3.00998216833E-02 3.04783465801E-02 3.08616294002E-02 3.12497298531E-02 3.16427083932E-02 3.20406262288E-02 3.24435453311E-02 3.28515284436E-02 3.32646390915E-02 3.36829415909E-02 3.41065010585E-02 3.45353834209E-02 3.49696554248E-02 3.54093846464E-02 3.58546395012E-02 3.63054892543E-02 3.67620040301E-02 3.72242548227E-02 3.76923135058E-02 3.81662528433E-02 3.86461464993E-02 3.91320690489E-02 3.96240959882E-02 4.01223037454E-02 4.06267696910E-02 4.11375721486E-02 4.16547904053E-02 4.21785047231E-02 4.27087963491E-02 4.32457475262E-02 4.37894415045E-02 4.43399625516E-02 4.48973959635E-02 4.54618280753E-02 4.60333462723E-02 4.66120390004E-02 4.71979957767E-02 4.77913072001E-02 4.83920649620E-02 4.90003618562E-02 4.96162917895E-02 5.02399497915E-02 5.08714320245E-02 5.15108357931E-02 5.21582595536E-02 5.28138029230E-02 5.34775666878E-02 5.41496528123E-02 5.48301644466E-02 5.55192059341E-02 5.62168828185E-02 5.69233018500E-02 5.76385709914E-02 5.83627994228E-02 5.90960975461E-02 5.98385769883E-02 6.05903506038E-02 6.13515324761E-02 6.21222379177E-02 6.29025834693E-02 6.36926868971E-02 6.44926671890E-02 6.53026445492E-02 6.61227403899E-02 6.69530773227E-02 6.77937791464E-02 6.86449708328E-02 6.95067785105E-02 7.03793294448E-02 7.12627520150E-02 7.21571756889E-02 7.30627309923E-02 7.39795494754E-02 7.49077636747E-02 7.58475070699E-02 7.67989140358E-02 7.77621197881E-02 7.87372603242E-02 7.97244723556E-02 8.07238932348E-02 8.17356608735E-02 8.27599136520E-02 8.37967903202E-02 8.48464298878E-02 8.59089715044E-02 8.69845543272E-02 8.80733173763E-02 8.91753993765E-02 9.02909385834E-02 9.14200725943E-02 9.25629381414E-02 9.37196708655E-02 9.48904050708E-02 9.60752734561E-02 9.72744068240E-02 9.84879337632E-02 9.97159803036E-02 1.00958669543E-01 1.02216121239E-01 1.03488451369E-01 1.04775771656E-01 1.06078189043E-01 1.07395805140E-01 1.08728715617E-01 1.10077009543E-01 1.11440768683E-01 1.12820066733E-01 1.14214968490E-01 1.15625528965E-01 1.17051792423E-01 1.18493791347E-01 1.19951545326E-01 1.21425059860E-01 1.22914325066E-01 1.24419314304E-01 1.25939982687E-01 1.27476265493E-01 1.29028076460E-01 1.30595305955E-01 1.32177819029E-01 1.33775453326E-01 1.35388016853E-01 1.37015285609E-01 1.38657001049E-01 1.40312867396E-01 1.41982548773E-01 1.43665666168E-01 1.45361794215E-01 1.47070457783E-01 1.48791128377E-01 1.50523220339E-01 1.52266086846E-01 1.54019015705E-01 1.55781224944E-01 1.57551858195E-01 1.59329979875E-01 1.61114570165E-01 1.62904519801E-01 1.64698624678E-01 1.66495580282E-01 1.68293975971E-01 1.70092289114E-01 1.71888879126E-01 1.73681981415E-01 1.75469701285E-01 1.77250007834E-01 1.79020727885E-01 1.80779540021E-01 1.82523968760E-01 1.84251378973E-01 1.85958970580E-01 1.87643773653E-01 1.89302643980E-01 1.90932259223E-01 1.92529115769E-01 1.94089526383E-01 1.95609618820E-01 1.97085335493E-01 1.98512434375E-01 1.99886491248E-01 2.01202903481E-01 2.02456895447E-01 2.03643525769E-01 2.04757696506E-01 2.05794164426E-01 2.06747554489E-01 2.07612375645E-01 2.08383039014E-01 2.09053878532E-01 2.09619174045E-01 2.10073176867E-01 2.10410137704E-01 2.10624336848E-01 2.10710116446E-01 2.10661914607E-01 2.10474301030E-01 2.10142013766E-01 2.09659996655E-01 2.09023436891E-01 2.08227802104E-01 2.07268876273E-01 2.06142793724E-01 2.04846070408E-01 2.03375631618E-01 2.01728835287E-01 1.99903490015E-01 1.97897866981E-01 1.95710704990E-01 1.93341207966E-01 1.90789034365E-01 1.88054278151E-01 1.85137441189E-01 1.82039397216E-01 1.78761347871E-01 1.75304771622E-01 1.71671366924E-01 1.67862991402E-01 1.63881599413E-01 1.59729180962E-01 1.55407705581E-01 1.50919075446E-01 1.46265092693E-01 1.41447446514E-01 1.36467726175E-01 1.31327466462E-01 1.26028229858E-01 1.20571700234E-01 1.14959711121E-01 1.09194247830E-01 1.03277447448E-01 9.72115986651E-02 9.09991414221E-02 8.46426663770E-02 7.81449141846E-02 7.15087745810E-02 6.47372852703E-02 5.78336306070E-02 5.08011400709E-02 4.36432865300E-02 3.63636842902E-02 2.89660869301E-02 2.14543849217E-02 1.38326030393E-02 6.10489756178E-03 -1.72444672570E-03 -9.65101971946E-03 -1.76702893631E-02 -2.57776051749E-02 -3.39682019180E-02 -4.22372033916E-02 -5.05796263168E-02 -5.89903842896E-02 -6.74642917701E-02 -7.59960680731E-02 -8.45803413255E-02 -9.32116523548E-02 -1.01884458470E-01 -1.10593137100E-01 -1.19331989252E-01 -1.28095242766E-01 -1.36877055318E-01 -1.45671517172E-01 -1.54472653645E-01 -1.63274427280E-01 -1.72070739722E-01 -1.80855433311E-01 -1.89622292386E-01 -1.98365044357E-01 -2.07077360546E-01 -2.15752856865E-01 -2.24385094387E-01 -2.32967579856E-01 -2.41493766238E-01 -2.49957053373E-01 -2.58350788833E-01 -2.66668269080E-01 -2.74902741020E-01 -2.83047404063E-01 -2.91095412792E-01 -2.99039880344E-01 -3.06873882608E-01 -3.14590463325E-01 -3.22182640190E-01 -3.29643412027E-01 -3.36965767103E-01 -3.44142692631E-01 -3.51167185499E-01 -3.58032264244E-01 -3.64730982260E-01 -3.71256442227E-01 -3.77601811705E-01 -3.83760339841E-01 -3.89725375090E-01 -3.95490383821E-01 -4.01048969747E-01 -4.06394893950E-01 -4.11522095394E-01 -4.16424711723E-01 -4.21097100180E-01 -4.25533858433E-01 -4.29729845135E-01 -4.33680200001E-01 -4.37380363232E-01 -4.40826094091E-01 -4.44013488457E-01 -4.46938995208E-01 -4.49599431281E-01 -4.51991995290E-01 -4.54114279592E-01 -4.55964280718E-01 -4.57540408109E-01 -4.58841491104E-01 -4.59866784173E-01 -4.60615970374E-01 -4.61089163063E-01 -4.61286905878E-01 -4.61210171058E-01 -4.60860356139E-01 -4.60239279113E-01 -4.59349172122E-01 -4.58192673780E-01 -4.56772820209E-01 -4.55093034897E-01 -4.53157117464E-01 -4.50969231448E-01 -4.48533891208E-01 -4.45855948033E-01 -4.42940575565E-01 -4.39793254629E-01 -4.36419757541E-01 -4.32826132009E-01 -4.29018684677E-01 -4.25003964411E-01 -4.20788745380E-01 -4.16380010021E-01 -4.11784931917E-01 -4.07010858679E-01 -4.02065294860E-01 -3.96955884959E-01 -3.91690396559E-01 -3.86276703627E-01 -3.80722770039E-01 -3.75036633327E-01 -3.69226388702E-01 -3.63300173378E-01 -3.57266151208E-01 -3.51132497658E-01 -3.44907385152E-01 -3.38598968775E-01 -3.32215372384E-01 -3.25764675108E-01 -3.19254898270E-01 -3.12693992732E-01 -3.06089826671E-01 -2.99450173798E-01 -2.92782702024E-01 -2.86094962574E-01 -2.79394379567E-01 -2.72688240047E-01 -2.65983684484E-01 -2.59287697745E-01 -2.52607100522E-01 -2.45948541245E-01 -2.39318488459E-01 -2.32723223668E-01 -2.26168834665E-01 -2.19661209320E-01 -2.13206029851E-01 -2.06808767560E-01 -2.00474678037E-01 -1.94208796846E-01 -1.88015935656E-01 -1.81900678860E-01 -1.75867380640E-01 -1.69920162502E-01 -1.64062911260E-01 -1.58299277484E-01 -1.52632674385E-01 -1.47066277159E-01 -1.41603022762E-01 -1.36245610124E-01 -1.30996500796E-01 -1.25857920011E-01 -1.20831858174E-01 -1.15920072750E-01 -1.11124090554E-01 -1.06445210436E-01 -1.01884506338E-01 -9.74430970172E-02 -9.31242722015E-02 -8.89284560993E-02 -8.48556003108E-02 -8.09054840650E-02 -7.70777176422E-02 -7.33717462004E-02 -6.97868539891E-02 -6.63221689360E-02 -6.29766675872E-02 -5.97491803857E-02 -5.66383972651E-02 -5.36428735401E-02 -5.07610360695E-02 -4.79911896697E-02 -4.53315237527E-02 -4.27801191651E-02 -4.03349552005E-02 -3.79939167593E-02 -3.57548016285E-02 -3.36153278540E-02 -3.15731411776E-02 -2.96258225110E-02 -2.77708954187E-02 -2.60058335821E-02 -2.43280682189E-02 -2.27349954292E-02 -2.12239834435E-02 -1.97923797478E-02 -1.84375180597E-02 -1.71567251345E-02 -1.59473273768E-02 -1.48066572391E-02 -1.37320593866E-02 -1.27208966102E-02 -1.17705554719E-02 -1.08784516680E-02 -1.00420350954E-02 -9.25879461258E-03 -8.52626248246E-03 -7.84201849200E-03 -7.20369374113E-03 -6.60897409755E-03 -6.05560331489E-03 -5.54138581381E-03 -5.06418912727E-03 -4.62194601280E-03 -4.21265623651E-03 -3.83438803481E-03 -3.48527926152E-03 -3.16353822935E-03 -2.86744425610E-03 -2.59534792687E-03 -2.34567108512E-03 -2.11690656583E-03 -1.90761768519E-03 -1.71643750201E-03 -1.54206786626E-03 -1.38327827099E-03 -1.23890452413E-03 -1.10784725661E-03 -9.89070283763E-04 -8.81598836599E-04 -7.84517679545E-04 -6.96969131013E-04 -6.18151002743E-04 -5.47314473474E-04 -4.83761911961E-04 -4.26844663749E-04 -3.75960815453E-04 -3.30552949560E-04 -2.90105902011E-04 -2.54144533985E-04 -2.22231528487E-04 -1.93965221483E-04 -1.68977476448E-04 -1.46931610355E-04 -1.27520378276E-04 -1.10464022943E-04 -9.55083948535E-05 -8.24231477562E-05 -7.10000136898E-05 -6.10511611533E-05 -5.24076394780E-05 -4.49179120809E-05 -3.84464810113E-05 -3.28726050937E-05 -2.80891140499E-05 -2.40013212882E-05 -2.04620834824E-05 -1.74048338839E-05 -1.47700791413E-05 -1.25047811156E-05 -1.05617762158E-05 -8.89923192879E-06 -7.48013996239E-06 -6.27184518880E-06 -5.24560937995E-06 -4.37620855606E-06 -3.64156263041E-06 -3.02239592039E-06 -2.50192700917E-06 -2.06558637963E-06 -1.70076020301E-06 -1.39655864490E-06 -1.14360705039E-06 -9.33858385602E-07 -7.60425342286E-07 -6.17430554257E-07 -4.99873426663E-07 -4.03512139907E-07 -3.24759457555E-07 -2.60591040161E-07 -2.08465043155E-07 -1.66251855270E-07 -1.32172913349E-07 -1.04747608553E-07 -8.27473770861E-08 -6.51561447791E-08 -5.11363685011E-08 -3.99999879157E-08 -3.11836680781E-08 -2.42277765300E-08 -1.87585976362E-08 -1.44733418188E-08 -1.11275580340E-08 -8.52460433252E-09 -6.50687372535E-09 -4.94851098464E-09 -3.74939060207E-09 -2.83015711580E-09 -2.12815661394E-09 -1.59411266729E-09 -1.18942147619E-09 -8.83959882319E-10 -6.54316336972E-10 -4.82369168683E-10 -3.54148782124E-10 -2.58930960838E-10 -1.88517440671E-10 -1.36667555344E-10 -9.86512023147E-11 -7.08987924917E-11 -5.07283726612E-11 -3.61338713977E-11 -2.56215300891E-11 -1.80841397813E-11 -1.27047986268E-11 -8.88360925831E-12 -6.18211552585E-12 -4.28138951947E-12 -2.95057015722E-12 -2.02336399773E-12 -1.38058106617E-12 -9.37221499610E-13 -6.32976045532E-13 -4.25274093857E-13 -2.84222703803E-13 -1.88941777771E-13 -1.24924455201E-13 -8.21462312846E-14 -5.37178522807E-14 -3.49309328220E-14 -2.25855993328E-14 -1.45195083144E-14 -9.27982154359E-15 -5.89607417505E-15 -3.72382810489E-15 -2.33769072235E-15 -1.45855288067E-15 -9.04402063992E-16 -5.57277192981E-16 -3.41206304447E-16 2P 1 1.50 Wavefunction 5.83977816897E-08 5.98761285255E-08 6.13918998873E-08 6.29460431814E-08 6.45395297976E-08 6.61733557169E-08 6.78485421334E-08 6.95661360928E-08 7.13272111472E-08 7.31328680256E-08 7.49842353219E-08 7.68824702007E-08 7.88287591205E-08 8.08243185747E-08 8.28703958527E-08 8.49682698192E-08 8.71192517132E-08 8.93246859681E-08 9.15859510517E-08 9.39044603280E-08 9.62816629403E-08 9.87190447171E-08 1.01218129101E-07 1.03780478100E-07 1.06407693267E-07 1.09101416694E-07 1.11863332047E-07 1.14695165611E-07 1.17598687375E-07 1.20575712133E-07 1.23628100623E-07 1.26757760684E-07 1.29966648457E-07 1.33256769599E-07 1.36630180543E-07 1.40088989780E-07 1.43635359176E-07 1.47271505327E-07 1.50999700942E-07 1.54822276264E-07 1.58741620525E-07 1.62760183441E-07 1.66880476745E-07 1.71105075752E-07 1.75436620972E-07 1.79877819762E-07 1.84431448013E-07 1.89100351890E-07 1.93887449608E-07 1.98795733256E-07 2.03828270671E-07 2.08988207350E-07 2.14278768419E-07 2.19703260648E-07 2.25265074521E-07 2.30967686349E-07 2.36814660447E-07 2.42809651363E-07 2.48956406157E-07 2.55258766749E-07 2.61720672317E-07 2.68346161757E-07 2.75139376214E-07 2.82104561664E-07 2.89246071570E-07 2.96568369606E-07 3.04076032441E-07 3.11773752605E-07 3.19666341418E-07 3.27758732002E-07 3.36055982358E-07 3.44563278532E-07 3.53285937856E-07 3.62229412270E-07 3.71399291731E-07 3.80801307704E-07 3.90441336750E-07 4.00325404193E-07 4.10459687889E-07 4.20850522087E-07 4.31504401389E-07 4.42427984807E-07 4.53628099927E-07 4.65111747176E-07 4.76886104197E-07 4.88958530335E-07 5.01336571239E-07 5.14027963574E-07 5.27040639863E-07 5.40382733437E-07 5.54062583526E-07 5.68088740467E-07 5.82469971050E-07 5.97215263994E-07 6.12333835572E-07 6.27835135365E-07 6.43728852172E-07 6.60024920062E-07 6.76733524588E-07 6.93865109151E-07 7.11430381525E-07 7.29440320553E-07 7.47906183008E-07 7.66839510629E-07 7.86252137334E-07 8.06156196617E-07 8.26564129132E-07 8.47488690468E-07 8.68942959125E-07 8.90940344682E-07 9.13494596183E-07 9.36619810730E-07 9.60330442293E-07 9.84641310746E-07 1.00956761113E-06 1.03512492313E-06 1.06132922087E-06 1.08819688282E-06 1.11574470209E-06 1.14398989691E-06 1.17295012138E-06 1.20264347651E-06 1.23308852156E-06 1.26430428560E-06 1.29631027941E-06 1.32912650770E-06 1.36277348161E-06 1.39727223150E-06 1.43264432011E-06 1.46891185606E-06 1.50609750763E-06 1.54422451696E-06 1.58331671456E-06 1.62339853421E-06 1.66449502821E-06 1.70663188309E-06 1.74983543562E-06 1.79413268927E-06 1.83955133112E-06 1.88611974913E-06 1.93386704992E-06 1.98282307692E-06 2.03301842906E-06 2.08448447986E-06 2.13725339709E-06 2.19135816282E-06 2.24683259404E-06 2.30371136387E-06 2.36203002311E-06 2.42182502257E-06 2.48313373578E-06 2.54599448241E-06 2.61044655215E-06 2.67653022931E-06 2.74428681802E-06 2.81375866798E-06 2.88498920099E-06 2.95802293805E-06 3.03290552720E-06 3.10968377208E-06 3.18840566112E-06 3.26912039757E-06 3.35187843028E-06 3.43673148516E-06 3.52373259759E-06 3.61293614550E-06 3.70439788338E-06 3.79817497715E-06 3.89432603986E-06 3.99291116833E-06 4.09399198073E-06 4.19763165504E-06 4.30389496861E-06 4.41284833858E-06 4.52455986343E-06 4.63909936552E-06 4.75653843476E-06 4.87695047330E-06 5.00041074146E-06 5.12699640474E-06 5.25678658205E-06 5.38986239515E-06 5.52630701939E-06 5.66620573565E-06 5.80964598364E-06 5.95671741659E-06 6.10751195724E-06 6.26212385533E-06 6.42064974644E-06 6.58318871247E-06 6.74984234351E-06 6.92071480132E-06 7.09591288448E-06 7.27554609510E-06 7.45972670727E-06 7.64856983722E-06 7.84219351528E-06 8.04071875961E-06 8.24426965190E-06 8.45297341484E-06 8.66696049167E-06 8.88636462772E-06 9.11132295397E-06 9.34197607273E-06 9.57846814557E-06 9.82094698337E-06 1.00695641387E-05 1.03244750006E-05 1.05858388915E-05 1.08538191671E-05 1.11285833182E-05 1.14103030754E-05 1.16991545165E-05 1.19953181766E-05 1.22989791608E-05 1.26103272599E-05 1.29295570690E-05 1.32568681092E-05 1.35924649521E-05 1.39365573481E-05 1.42893603567E-05 1.46510944817E-05 1.50219858084E-05 1.54022661453E-05 1.57921731686E-05 1.61919505711E-05 1.66018482143E-05 1.70221222843E-05 1.74530354524E-05 1.78948570389E-05 1.83478631814E-05 1.88123370075E-05 1.92885688116E-05 1.97768562364E-05 2.02775044589E-05 2.07908263810E-05 2.13171428249E-05 2.18567827341E-05 2.24100833783E-05 2.29773905645E-05 2.35590588531E-05 2.41554517794E-05 2.47669420805E-05 2.53939119287E-05 2.60367531699E-05 2.66958675686E-05 2.73716670587E-05 2.80645740015E-05 2.87750214487E-05 2.95034534139E-05 3.02503251494E-05 3.10161034308E-05 3.18012668486E-05 3.26063061076E-05 3.34317243329E-05 3.42780373847E-05 3.51457741802E-05 3.60354770245E-05 3.69477019492E-05 3.78830190595E-05 3.88420128909E-05 3.98252827740E-05 4.08334432091E-05 4.18671242501E-05 4.29269718978E-05 4.40136485040E-05 4.51278331847E-05 4.62702222450E-05 4.74415296132E-05 4.86424872878E-05 4.98738457937E-05 5.11363746520E-05 5.24308628599E-05 5.37581193839E-05 5.51189736653E-05 5.65142761378E-05 5.79448987590E-05 5.94117355550E-05 6.09157031787E-05 6.24577414825E-05 6.40388141049E-05 6.56599090730E-05 6.73220394187E-05 6.90262438123E-05 7.07735872104E-05 7.25651615214E-05 7.44020862872E-05 7.62855093823E-05 7.82166077309E-05 8.01965880414E-05 8.22266875602E-05 8.43081748440E-05 8.64423505524E-05 8.86305482592E-05 9.08741352859E-05 9.31745135546E-05 9.55331204641E-05 9.79514297863E-05 1.00430952587E-04 1.02973238170E-04 1.05579875041E-04 1.08252491904E-04 1.10992758675E-04 1.13802387522E-04 1.16683133940E-04 1.19636797843E-04 1.22665224685E-04 1.25770306616E-04 1.28953983662E-04 1.32218244934E-04 1.35565129871E-04 1.38996729510E-04 1.42515187794E-04 1.46122702909E-04 1.49821528654E-04 1.53613975848E-04 1.57502413773E-04 1.61489271648E-04 1.65577040151E-04 1.69768272966E-04 1.74065588379E-04 1.78471670912E-04 1.82989272996E-04 1.87621216687E-04 1.92370395426E-04 1.97239775847E-04 2.02232399619E-04 2.07351385352E-04 2.12599930533E-04 2.17981313525E-04 2.23498895609E-04 2.29156123077E-04 2.34956529385E-04 2.40903737350E-04 2.47001461412E-04 2.53253509946E-04 2.59663787636E-04 2.66236297908E-04 2.72975145426E-04 2.79884538645E-04 2.86968792436E-04 2.94232330773E-04 3.01679689488E-04 3.09315519095E-04 3.17144587687E-04 3.25171783904E-04 3.33402119977E-04 3.41840734850E-04 3.50492897374E-04 3.59364009593E-04 3.68459610100E-04 3.77785377485E-04 3.87347133871E-04 3.97150848532E-04 4.07202641610E-04 4.17508787918E-04 4.28075720845E-04 4.38910036354E-04 4.50018497086E-04 4.61408036560E-04 4.73085763485E-04 4.85058966180E-04 4.97335117098E-04 5.09921877471E-04 5.22827102071E-04 5.36058844085E-04 5.49625360119E-04 5.63535115322E-04 5.77796788642E-04 5.92419278216E-04 6.07411706886E-04 6.22783427863E-04 6.38544030531E-04 6.54703346391E-04 6.71271455157E-04 6.88258691010E-04 7.05675648998E-04 7.23533191609E-04 7.41842455491E-04 7.60614858362E-04 7.79862106072E-04 7.99596199856E-04 8.19829443760E-04 8.40574452258E-04 8.61844158054E-04 8.83651820085E-04 9.06011031715E-04 9.28935729142E-04 9.52440200011E-04 9.76539092240E-04 1.00124742307E-03 1.02658058834E-03 1.05255437197E-03 1.07918495574E-03 1.10648892925E-03 1.13448330014E-03 1.16318550458E-03 1.19261341805E-03 1.22278536630E-03 1.25372013667E-03 1.28543698963E-03 1.31795567067E-03 1.35129642240E-03 1.38547999703E-03 1.42052766911E-03 1.45646124859E-03 1.49330309424E-03 1.53107612733E-03 1.56980384574E-03 1.60951033835E-03 1.65022029977E-03 1.69195904553E-03 1.73475252753E-03 1.77862734993E-03 1.82361078544E-03 1.86973079199E-03 1.91701602977E-03 1.96549587877E-03 2.01520045671E-03 2.06616063737E-03 2.11840806943E-03 2.17197519575E-03 2.22689527308E-03 2.28320239234E-03 2.34093149929E-03 2.40011841579E-03 2.46079986151E-03 2.52301347621E-03 2.58679784256E-03 2.65219250947E-03 2.71923801605E-03 2.78797591608E-03 2.85844880313E-03 2.93070033626E-03 3.00477526630E-03 3.08071946287E-03 3.15857994190E-03 3.23840489396E-03 3.32024371315E-03 3.40414702676E-03 3.49016672557E-03 3.57835599495E-03 3.66876934664E-03 3.76146265128E-03 3.85649317177E-03 3.95391959736E-03 4.05380207858E-03 4.15620226300E-03 4.26118333175E-03 4.36881003704E-03 4.47914874042E-03 4.59226745205E-03 4.70823587076E-03 4.82712542518E-03 4.94900931573E-03 5.07396255759E-03 5.20206202474E-03 5.33338649489E-03 5.46801669557E-03 5.60603535118E-03 5.74752723119E-03 5.89257919934E-03 6.04128026408E-03 6.19372163007E-03 6.34999675086E-03 6.51020138275E-03 6.67443363989E-03 6.84279405057E-03 7.01538561477E-03 7.19231386303E-03 7.37368691656E-03 7.55961554870E-03 7.75021324772E-03 7.94559628101E-03 8.14588376064E-03 8.35119771033E-03 8.56166313387E-03 8.77740808504E-03 8.99856373893E-03 9.22526446485E-03 9.45764790076E-03 9.69585502920E-03 9.94003025489E-03 1.01903214838E-02 1.04468802041E-02 1.07098615684E-02 1.09794244777E-02 1.12557316678E-02 1.15389497959E-02 1.18292495307E-02 1.21268056425E-02 1.24317970968E-02 1.27444071481E-02 1.30648234365E-02 1.33932380861E-02 1.37298478044E-02 1.40748539846E-02 1.44284628091E-02 1.47908853548E-02 1.51623377011E-02 1.55430410386E-02 1.59332217807E-02 1.63331116764E-02 1.67429479256E-02 1.71629732958E-02 1.75934362409E-02 1.80345910219E-02 1.84866978295E-02 1.89500229085E-02 1.94248386842E-02 1.99114238903E-02 2.04100636991E-02 2.09210498532E-02 2.14446807989E-02 2.19812618217E-02 2.25311051828E-02 2.30945302584E-02 2.36718636794E-02 2.42634394732E-02 2.48695992072E-02 2.54906921335E-02 2.61270753348E-02 2.67791138716E-02 2.74471809314E-02 2.81316579774E-02 2.88329348999E-02 2.95514101675E-02 3.02874909796E-02 3.10415934188E-02 3.18141426050E-02 3.26055728488E-02 3.34163278055E-02 3.42468606291E-02 3.50976341260E-02 3.59691209087E-02 3.68618035483E-02 3.77761747263E-02 3.87127373863E-02 3.96720048828E-02 4.06545011293E-02 4.16607607450E-02 4.26913291976E-02 4.37467629457E-02 4.48276295763E-02 4.59345079400E-02 4.70679882830E-02 4.82286723735E-02 4.94171736248E-02 5.06341172129E-02 5.18801401883E-02 5.31558915822E-02 5.44620325056E-02 5.57992362412E-02 5.71681883280E-02 5.85695866362E-02 6.00041414339E-02 6.14725754433E-02 6.29756238865E-02 6.45140345188E-02 6.60885676510E-02 6.76999961570E-02 6.93491054678E-02 7.10366935504E-02 7.27635708694E-02 7.45305603324E-02 7.63384972161E-02 7.81882290726E-02 8.00806156149E-02 8.20165285801E-02 8.39968515688E-02 8.60224798591E-02 8.80943201945E-02 9.02132905433E-02 9.23803198278E-02 9.45963476226E-02 9.68623238196E-02 9.91792082570E-02 1.01547970313E-01 1.03969588458E-01 1.06445049768E-01 1.08975349395E-01 1.11561489990E-01 1.14204481078E-01 1.16905338388E-01 1.19665083124E-01 1.22484741185E-01 1.25365342329E-01 1.28307919272E-01 1.31313506726E-01 1.34383140376E-01 1.37517855782E-01 1.40718687214E-01 1.43986666410E-01 1.47322821259E-01 1.50728174403E-01 1.54203741756E-01 1.57750530931E-01 1.61369539591E-01 1.65061753690E-01 1.68828145631E-01 1.72669672320E-01 1.76587273116E-01 1.80581867681E-01 1.84654353716E-01 1.88805604588E-01 1.93036466848E-01 1.97347757621E-01 2.01740261890E-01 2.06214729645E-01 2.10771872919E-01 2.15412362693E-01 2.20136825674E-01 2.24945840944E-01 2.29839936477E-01 2.34819585532E-01 2.39885202909E-01 2.45037141074E-01 2.50275686159E-01 2.55601053830E-01 2.61013385030E-01 2.66512741598E-01 2.72099101767E-01 2.77772355546E-01 2.83532299999E-01 2.89378634406E-01 2.95310955338E-01 3.01328751643E-01 3.07431399347E-01 3.13618156491E-01 3.19888157919E-01 3.26240410010E-01 3.32673785400E-01 3.39187017685E-01 3.45778696138E-01 3.52447260456E-01 3.59190995557E-01 3.66008026464E-01 3.72896313284E-01 3.79853646319E-01 3.86877641353E-01 3.93965735120E-01 4.01115181015E-01 4.08323045068E-01 4.15586202231E-01 4.22901333007E-01 4.30264920487E-01 4.37673247810E-01 4.45122396128E-01 4.52608243095E-01 4.60126461949E-01 4.67672521242E-01 4.75241685256E-01 4.82829015172E-01 4.90429371050E-01 4.98037414665E-01 5.05647613261E-01 5.13254244277E-01 5.20851401097E-01 5.28432999880E-01 5.35992787511E-01 5.43524350724E-01 5.51021126444E-01 5.58476413370E-01 5.65883384850E-01 5.73235103055E-01 5.80524534484E-01 5.87744566792E-01 5.94888026964E-01 6.01947700804E-01 6.08916353715E-01 6.15786752760E-01 6.22551689921E-01 6.29204006519E-01 6.35736618701E-01 6.42142543907E-01 6.48414928199E-01 6.54547074322E-01 6.60532470355E-01 6.66364818775E-01 6.72038065753E-01 6.77546430478E-01 6.82884434284E-01 6.88046929331E-01 6.93029126599E-01 6.97826622896E-01 7.02435426607E-01 7.06851981866E-01 7.11073190849E-01 7.15096433844E-01 7.18919586785E-01 7.22541035887E-01 7.25959689074E-01 7.29174983837E-01 7.32186891203E-01 7.34995915503E-01 7.37603089612E-01 7.40009965407E-01 7.42218599143E-01 7.44231531557E-01 7.46051762475E-01 7.47682719785E-01 7.49128222669E-01 7.50392439050E-01 7.51479837278E-01 7.52395132138E-01 7.53143225377E-01 7.53729141008E-01 7.54157955781E-01 7.54434725329E-01 7.54564406616E-01 7.54551777483E-01 7.54401354252E-01 7.54117308520E-01 7.53703384493E-01 7.53162818415E-01 7.52498261879E-01 7.51711711054E-01 7.50804444088E-01 7.49776969210E-01 7.48628986226E-01 7.47359364328E-01 7.45966139200E-01 7.44446532457E-01 7.42796996315E-01 7.41013286086E-01 7.39090562555E-01 7.37023525424E-01 7.34806577744E-01 7.32434019509E-01 7.29900266190E-01 7.27200084895E-01 7.24328836827E-01 7.21282709676E-01 7.18058917245E-01 7.14655835861E-01 7.11073037571E-01 7.07311168554E-01 7.03371619771E-01 6.99256085795E-01 6.94966424828E-01 6.90504648194E-01 6.85872919661E-01 6.81073554622E-01 6.76109019119E-01 6.70981928724E-01 6.65695047240E-01 6.60251285242E-01 6.54653698426E-01 6.48905485763E-01 6.43009987441E-01 6.36970682587E-01 6.30791186739E-01 6.24475249074E-01 6.18026749342E-01 6.11449694528E-01 6.04748215180E-01 5.97926561425E-01 5.90989098633E-01 5.83940302711E-01 5.76784755033E-01 5.69527136976E-01 5.62172224060E-01 5.54724879693E-01 5.47190048519E-01 5.39572749365E-01 5.31878067821E-01 5.24111148444E-01 5.16277186636E-01 5.08381420206E-01 5.00429120672E-01 4.92425584332E-01 4.84376123161E-01 4.76286055603E-01 4.68160697290E-01 4.60005351780E-01 4.51825301369E-01 4.43625798050E-01 4.35412054683E-01 4.27189236451E-01 4.18962452667E-01 4.10736748985E-01 4.02517100088E-01 3.94308402889E-01 3.86115470296E-01 3.77943025577E-01 3.69795697341E-01 3.61678015176E-01 3.53594405919E-01 3.45549190585E-01 3.37546581924E-01 3.29590682596E-01 3.21685483924E-01 3.13834865195E-01 3.06042593452E-01 2.98312323737E-01 2.90647599704E-01 2.83051854565E-01 2.75528412273E-01 2.68080488894E-01 2.60711194083E-01 2.53423532596E-01 2.46220405776E-01 2.39104612932E-01 2.32078852567E-01 2.25145723386E-01 2.18307725046E-01 2.11567258592E-01 2.04926626572E-01 1.98388032780E-01 1.91953581641E-01 1.85625277216E-01 1.79405021849E-01 1.73294614471E-01 1.67295748584E-01 1.61410009966E-01 1.55638874143E-01 1.49983703673E-01 1.44445745299E-01 1.39026127042E-01 1.33725855273E-01 1.28545811858E-01 1.23486751403E-01 1.18549298696E-01 1.13733946379E-01 1.09041052914E-01 1.04470840890E-01 1.00023395718E-01 9.56986647506E-02 9.14964568472E-02 8.74164424287E-02 8.34581540198E-02 7.96209872999E-02 7.59042026641E-02 7.23069272910E-02 6.88281577105E-02 6.54667628575E-02 6.22214875935E-02 5.90909566734E-02 5.60736791310E-02 5.31680530546E-02 5.03723707193E-02 4.76848240438E-02 4.51035103341E-02 4.26264382794E-02 4.02515341611E-02 3.79766482389E-02 3.57995612762E-02 3.37179911674E-02 3.17295996325E-02 2.98319989424E-02 2.80227586423E-02 2.62994122410E-02 2.46594638346E-02 2.31003946362E-02 2.16196693847E-02 2.02147426074E-02 1.88830647126E-02 1.76220878920E-02 1.64292718125E-02 1.53020890813E-02 1.42380304686E-02 1.32346098746E-02 1.22893690295E-02 1.13998819179E-02 1.05637589193E-02 9.77865065907E-03 9.04225156641E-03 8.35230313705E-03 7.70659689935E-03 7.10297708521E-03 6.53934300793E-03 6.01365115052E-03 5.52391696932E-03 5.06821641911E-03 4.64468720663E-03 4.25152978071E-03 3.88700806787E-03 3.54944996332E-03 3.23724758767E-03 2.94885732058E-03 2.68279962281E-03 2.43765865891E-03 2.21208173276E-03 2.00477854870E-03 1.81452031116E-03 1.64013867553E-03 1.48052456346E-03 1.33462685531E-03 1.20145097267E-03 1.08005736350E-03 9.69559902245E-04 8.69124217017E-04 7.77965955545E-04 6.95349001160E-04 6.20583649696E-04 5.53024757656E-04 4.92069871498E-04 4.37157347307E-04 3.87764469586E-04 3.43405577234E-04 3.03631034959E-04 2.68031971094E-04 2.36222360407E-04 2.07845360549E-04 1.82572532194E-04 1.60102109129E-04 1.40157324311E-04 1.22484794486E-04 1.06852965495E-04 9.30506199808E-05 8.08854487485E-05 7.01826866364E-05 6.07838133591E-05 5.25453194127E-05 4.53375367903E-05 3.90435339307E-05 3.35580740345E-05 2.87866356066E-05 2.46444938492E-05 2.10558613115E-05 1.79530860160E-05 1.52759051200E-05 1.29707520377E-05 1.09901148363E-05 9.29194363425E-06 7.83910466825E-06 6.59887865240E-06 5.54250103331E-06 4.64474174209E-06 3.88352205921E-06 3.23956623895E-06 2.69608558458E-06 2.23849272275E-06 1.85414389327E-06 1.53210714831E-06 1.26295443992E-06 1.03857566736E-06 8.52012852907E-07 6.97312717304E-07 5.69396031156E-07 4.63942227886E-07 3.77287874883E-07 3.06337713919E-07 2.48487099268E-07 2.01554783758E-07 1.63032421872E-07 1.31501636065E-07 1.05766747035E-07 8.48227346083E-08 6.78273176399E-08 5.40767007183E-08 4.29845736423E-08 3.40639862218E-08 2.69117557565E-08 2.11950974524E-08 1.66401989470E-08 1.30224889864E-08 1.01583771041E-08 7.89826590585E-09 6.12066029756E-09 4.72721876266E-09 3.63861066936E-09 2.79106065327E-09 2.13347647437E-09 1.62507049117E-09 1.23339713787E-09 9.32739644019E-10 7.02788811132E-10 5.27565067649E-10 3.94542369741E-10 2.93938903994E-10 2.18145077621E-10 1.61264045307E-10 1.18744105826E-10 8.70857865544E-11 6.36093936910E-11 4.62713076079E-11 3.35194071940E-11 2.41797688348E-11 1.73682535772E-11 1.24218131648E-11 8.84534995415E-12 6.27079042229E-12 4.42570585191E-12 3.10936171983E-12 2.17452063337E-12 1.51368055279E-12 1.04871590905E-12 7.23117050036E-13 4.96204087310E-13 3.38833705393E-13 2.30229311669E-13 1.55652191859E-13 1.04699116077E-13 7.00641934206E-14 4.66429934453E-14 3.08876853579E-14 2.03453002847E-14 1.33288720337E-14 8.68447652483E-15 5.62710309260E-15 3.62565709433E-15 2.32283563800E-15 1.47961598570E-15 9.37015601296E-16 5.89902176405E-16 3.69161362346E-16 2.29626938985E-16 1.41960221095E-16 8.72196208880E-17 5.32514528372E-17 3.23060663875E-17 1.94731961545E-17 1.16615338913E-17 6.93751132032E-18 4.09963479944E-18 2.40626512949E-18 1.40268956074E-18 8.12010991050E-19 4.66773841080E-19 2.66413909412E-19 1.50964248191E-19 8.49217042468E-20 4.74188186928E-20 2.62802656969E-20 1.44548906774E-20 7.88977179836E-21 4.27303700901E-21 2.29609012964E-21 1.22399099593E-21 6.47233423210E-22 3.39463380029E-22 1.76575121215E-22 9.10805040206E-23 4.65837924615E-23 2.36217115850E-23 1.18742995753E-23 5.91666776947E-24 2.92193624457E-24 1.43001264711E-24 6.93482043024E-25 3.33201346067E-25 1.58600232030E-25 7.47782254915E-26 3.49195657365E-26 1.61485034236E-26 7.39455861058E-27 3.35239245900E-27 1.50454608373E-27 6.68357620348E-28 2.93838784379E-28 1.27834909929E-28 5.50265869633E-29 2.34325922881E-29 9.87038097805E-30 4.11200603229E-30 1.69402375426E-30 6.90033370629E-31 2.77871297898E-31 1.10605737655E-31 4.35119534855E-32 1.69150098124E-32 6.49686220971E-33 2.46511368036E-33 9.23858540914E-34 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 3P 1 0.00 Wavefunction 1.50430739561E-08 1.54238911739E-08 1.58143488248E-08 1.62146909575E-08 1.66251677989E-08 1.70460359102E-08 1.74775583477E-08 1.79200048269E-08 1.83736518912E-08 1.88387830847E-08 1.93156891295E-08 1.98046681073E-08 2.03060256457E-08 2.08200751096E-08 2.13471377965E-08 2.18875431375E-08 2.24416289037E-08 2.30097414164E-08 2.35922357644E-08 2.41894760256E-08 2.48018354944E-08 2.54296969153E-08 2.60734527220E-08 2.67335052827E-08 2.74102671516E-08 2.81041613268E-08 2.88156215146E-08 2.95450924005E-08 3.02930299274E-08 3.10599015806E-08 3.18461866794E-08 3.26523766776E-08 3.34789754699E-08 3.43264997072E-08 3.51954791196E-08 3.60864568473E-08 3.69999897799E-08 3.79366489052E-08 3.88970196653E-08 3.98817023228E-08 4.08913123363E-08 4.19264807444E-08 4.29878545608E-08 4.40760971783E-08 4.51918887836E-08 4.63359267824E-08 4.75089262353E-08 4.87116203046E-08 4.99447607128E-08 5.12091182124E-08 5.25054830675E-08 5.38346655476E-08 5.51974964347E-08 5.65948275418E-08 5.80275322456E-08 5.94965060326E-08 6.10026670586E-08 6.25469567224E-08 6.41303402548E-08 6.57538073210E-08 6.74183726400E-08 6.91250766185E-08 7.08749860011E-08 7.26691945371E-08 7.45088236642E-08 7.63950232094E-08 7.83289721078E-08 8.03118791392E-08 8.23449836837E-08 8.44295564965E-08 8.65669005022E-08 8.87583516088E-08 9.10052795431E-08 9.33090887066E-08 9.56712190534E-08 9.80931469899E-08 1.00576386298E-07 1.03122489082E-07 1.05733046735E-07 1.08409690941E-07 1.11154094685E-07 1.13967973308E-07 1.16853085572E-07 1.19811234764E-07 1.22844269821E-07 1.25954086485E-07 1.29142628491E-07 1.32411888776E-07 1.35763910733E-07 1.39200789480E-07 1.42724673174E-07 1.46337764354E-07 1.50042321316E-07 1.53840659522E-07 1.57735153055E-07 1.61728236093E-07 1.65822404440E-07 1.70020217078E-07 1.74324297771E-07 1.78737336704E-07 1.83262092163E-07 1.87901392262E-07 1.92658136707E-07 1.97535298611E-07 2.02535926351E-07 2.07663145475E-07 2.12920160654E-07 2.18310257683E-07 2.23836805539E-07 2.29503258486E-07 2.35313158231E-07 2.41270136139E-07 2.47377915504E-07 2.53640313876E-07 2.60061245443E-07 2.66644723486E-07 2.73394862877E-07 2.80315882659E-07 2.87412108680E-07 2.94687976296E-07 3.02148033144E-07 3.09796941984E-07 3.17639483615E-07 3.25680559862E-07 3.33925196637E-07 3.42378547086E-07 3.51045894806E-07 3.59932657146E-07 3.69044388597E-07 3.78386784261E-07 3.87965683413E-07 3.97787073146E-07 4.07857092119E-07 4.18182034387E-07 4.28768353344E-07 4.39622665746E-07 4.50751755854E-07 4.62162579674E-07 4.73862269299E-07 4.85858137373E-07 4.98157681658E-07 5.10768589722E-07 5.23698743741E-07 5.36956225430E-07 5.50549321089E-07 5.64486526789E-07 5.78776553673E-07 5.93428333409E-07 6.08451023767E-07 6.23854014346E-07 6.39646932441E-07 6.55839649061E-07 6.72442285096E-07 6.89465217646E-07 7.06919086508E-07 7.24814800818E-07 7.43163545880E-07 7.61976790148E-07 7.81266292401E-07 8.01044109086E-07 8.21322601857E-07 8.42114445303E-07 8.63432634863E-07 8.85290494955E-07 9.07701687302E-07 9.30680219467E-07 9.54240453613E-07 9.78397115476E-07 1.00316530357E-06 1.02856049862E-06 1.05459857326E-06 1.08129580189E-06 1.10866887094E-06 1.13673488923E-06 1.16551139867E-06 1.19501638527E-06 1.22526829032E-06 1.25628602194E-06 1.28808896694E-06 1.32069700286E-06 1.35413051044E-06 1.38841038637E-06 1.42355805630E-06 1.45959548828E-06 1.49654520646E-06 1.53443030518E-06 1.57327446341E-06 1.61310195953E-06 1.65393768651E-06 1.69580716748E-06 1.73873657167E-06 1.78275273077E-06 1.82788315569E-06 1.87415605377E-06 1.92160034639E-06 1.97024568706E-06 2.02012247994E-06 2.07126189888E-06 2.12369590682E-06 2.17745727586E-06 2.23257960768E-06 2.28909735456E-06 2.34704584092E-06 2.40646128537E-06 2.46738082338E-06 2.52984253046E-06 2.59388544596E-06 2.65954959748E-06 2.72687602589E-06 2.79590681093E-06 2.86668509759E-06 2.93925512300E-06 3.01366224410E-06 3.08995296600E-06 3.16817497103E-06 3.24837714855E-06 3.33060962546E-06 3.41492379760E-06 3.50137236178E-06 3.59000934880E-06 3.68089015716E-06 3.77407158768E-06 3.86961187902E-06 3.96757074407E-06 4.06800940723E-06 4.17099064274E-06 4.27657881382E-06 4.38483991298E-06 4.49584160318E-06 4.60965326016E-06 4.72634601578E-06 4.84599280248E-06 4.96866839881E-06 5.09444947623E-06 5.22341464696E-06 5.35564451312E-06 5.49122171710E-06 5.63023099322E-06 5.77275922062E-06 5.91889547762E-06 6.06873109732E-06 6.22235972469E-06 6.37987737512E-06 6.54138249434E-06 6.70697601998E-06 6.87676144466E-06 7.05084488059E-06 7.22933512592E-06 7.41234373271E-06 7.59998507661E-06 7.79237642834E-06 7.98963802695E-06 8.19189315496E-06 8.39926821535E-06 8.61189281058E-06 8.82989982352E-06 9.05342550048E-06 9.28260953638E-06 9.51759516192E-06 9.75852923317E-06 1.00055623233E-05 1.02588488164E-05 1.05185470045E-05 1.07848191859E-05 1.10578317667E-05 1.13377553648E-05 1.16247649168E-05 1.19190397865E-05 1.22207638778E-05 1.25301257490E-05 1.28473187309E-05 1.31725410472E-05 1.35059959387E-05 1.38478917903E-05 1.41984422606E-05 1.45578664158E-05 1.49263888667E-05 1.53042399083E-05 1.56916556645E-05 1.60888782346E-05 1.64961558456E-05 1.69137430062E-05 1.73419006663E-05 1.77808963801E-05 1.82310044726E-05 1.86925062114E-05 1.91656899822E-05 1.96508514689E-05 2.01482938381E-05 2.06583279285E-05 2.11812724452E-05 2.17174541581E-05 2.22672081068E-05 2.28308778088E-05 2.34088154747E-05 2.40013822279E-05 2.46089483299E-05 2.52318934115E-05 2.58706067099E-05 2.65254873116E-05 2.71969444016E-05 2.78853975184E-05 2.85912768167E-05 2.93150233349E-05 3.00570892712E-05 3.08179382652E-05 3.15980456877E-05 3.23978989372E-05 3.32179977439E-05 3.40588544817E-05 3.49209944879E-05 3.58049563910E-05 3.67112924468E-05 3.76405688827E-05 3.85933662513E-05 3.95702797924E-05 4.05719198044E-05 4.15989120248E-05 4.26518980208E-05 4.37315355892E-05 4.48384991669E-05 4.59734802511E-05 4.71371878312E-05 4.83303488303E-05 4.95537085586E-05 5.08080311785E-05 5.20941001805E-05 5.34127188720E-05 5.47647108779E-05 5.61509206542E-05 5.75722140140E-05 5.90294786676E-05 6.05236247754E-05 6.20555855151E-05 6.36263176633E-05 6.52368021917E-05 6.68880448781E-05 6.85810769330E-05 7.03169556423E-05 7.20967650251E-05 7.39216165098E-05 7.57926496255E-05 7.77110327118E-05 7.96779636466E-05 8.16946705913E-05 8.37624127559E-05 8.58824811823E-05 8.80561995482E-05 9.02849249909E-05 9.25700489513E-05 9.49129980403E-05 9.73152349257E-05 9.97782592424E-05 1.02303608525E-04 1.04892859165E-04 1.07547627387E-04 1.10269570261E-04 1.13060386724E-04 1.15921818643E-04 1.18855651892E-04 1.21863717466E-04 1.24947892617E-04 1.28110102018E-04 1.31352318963E-04 1.34676566588E-04 1.38084919129E-04 1.41579503210E-04 1.45162499162E-04 1.48836142376E-04 1.52602724693E-04 1.56464595820E-04 1.60424164792E-04 1.64483901465E-04 1.68646338046E-04 1.72914070661E-04 1.77289760970E-04 1.81776137809E-04 1.86375998884E-04 1.91092212504E-04 1.95927719355E-04 2.00885534322E-04 2.05968748352E-04 2.11180530372E-04 2.16524129241E-04 2.22002875766E-04 2.27620184758E-04 2.33379557143E-04 2.39284582124E-04 2.45338939399E-04 2.51546401433E-04 2.57910835787E-04 2.64436207505E-04 2.71126581556E-04 2.77986125347E-04 2.85019111287E-04 2.92229919423E-04 2.99623040137E-04 3.07203076911E-04 3.14974749159E-04 3.22942895136E-04 3.31112474909E-04 3.39488573408E-04 3.48076403551E-04 3.56881309449E-04 3.65908769682E-04 3.75164400665E-04 3.84653960094E-04 3.94383350474E-04 4.04358622738E-04 4.14585979952E-04 4.25071781116E-04 4.35822545051E-04 4.46844954389E-04 4.58145859654E-04 4.69732283451E-04 4.81611424751E-04 4.93790663284E-04 5.06277564039E-04 5.19079881873E-04 5.32205566237E-04 5.45662766009E-04 5.59459834452E-04 5.73605334292E-04 5.88108042916E-04 6.02976957700E-04 6.18221301464E-04 6.33850528058E-04 6.49874328090E-04 6.66302634783E-04 6.83145629984E-04 7.00413750307E-04 7.18117693434E-04 7.36268424560E-04 7.54877183000E-04 7.73955488949E-04 7.93515150402E-04 8.13568270254E-04 8.34127253548E-04 8.55204814915E-04 8.76813986179E-04 8.98968124152E-04 9.21680918605E-04 9.44966400436E-04 9.68838950026E-04 9.93313305793E-04 1.01840457295E-03 1.04412823248E-03 1.07050015028E-03 1.09753658658E-03 1.12525420552E-03 1.15367008502E-03 1.18280172681E-03 1.21266706673E-03 1.24328448527E-03 1.27467281835E-03 1.30685136832E-03 1.33983991526E-03 1.37365872851E-03 1.40832857847E-03 1.44387074867E-03 1.48030704809E-03 1.51765982382E-03 1.55595197394E-03 1.59520696072E-03 1.63544882412E-03 1.67670219559E-03 1.71899231213E-03 1.76234503077E-03 1.80678684325E-03 1.85234489108E-03 1.89904698095E-03 1.94692160043E-03 1.99599793404E-03 2.04630587966E-03 2.09787606526E-03 2.15073986608E-03 2.20492942206E-03 2.26047765569E-03 2.31741829030E-03 2.37578586859E-03 2.43561577168E-03 2.49694423848E-03 2.55980838547E-03 2.62424622688E-03 2.69029669533E-03 2.75799966279E-03 2.82739596203E-03 2.89852740847E-03 2.97143682246E-03 3.04616805198E-03 3.12276599580E-03 3.20127662708E-03 3.28174701739E-03 3.36422536117E-03 3.44876100070E-03 3.53540445149E-03 3.62420742810E-03 3.71522287044E-03 3.80850497057E-03 3.90410919992E-03 4.00209233697E-03 4.10251249541E-03 4.20542915275E-03 4.31090317947E-03 4.41899686846E-03 4.52977396514E-03 4.64329969784E-03 4.75964080878E-03 4.87886558537E-03 5.00104389213E-03 5.12624720283E-03 5.25454863326E-03 5.38602297428E-03 5.52074672540E-03 5.65879812864E-03 5.80025720291E-03 5.94520577867E-03 6.09372753301E-03 6.24590802503E-03 6.40183473162E-03 6.56159708350E-03 6.72528650153E-03 6.89299643337E-03 7.06482239026E-03 7.24086198417E-03 7.42121496495E-03 7.60598325782E-03 7.79527100082E-03 7.98918458244E-03 8.18783267924E-03 8.39132629351E-03 8.59977879083E-03 8.81330593757E-03 9.03202593821E-03 9.25605947249E-03 9.48552973224E-03 9.72056245795E-03 9.96128597481E-03 1.02078312285E-02 1.04603318200E-02 1.07189240404E-02 1.09837469044E-02 1.12549421834E-02 1.15326544371E-02 1.18170310450E-02 1.21082222358E-02 1.24063811162E-02 1.27116636981E-02 1.30242289242E-02 1.33442386920E-02 1.36718578763E-02 1.40072543490E-02 1.43505989979E-02 1.47020657420E-02 1.50618315453E-02 1.54300764273E-02 1.58069834709E-02 1.61927388274E-02 1.65875317176E-02 1.69915544302E-02 1.74050023155E-02 1.78280737759E-02 1.82609702515E-02 1.87038962012E-02 1.91570590793E-02 1.96206693062E-02 2.00949402343E-02 2.05800881075E-02 2.10763320146E-02 2.15838938363E-02 2.21029981848E-02 2.26338723362E-02 2.31767461556E-02 2.37318520126E-02 2.42994246897E-02 2.48797012803E-02 2.54729210773E-02 2.60793254521E-02 2.66991577218E-02 2.73326630059E-02 2.79800880711E-02 2.86416811630E-02 2.93176918256E-02 3.00083707064E-02 3.07139693474E-02 3.14347399614E-02 3.21709351917E-02 3.29228078568E-02 3.36906106762E-02 3.44745959800E-02 3.52750153986E-02 3.60921195336E-02 3.69261576085E-02 3.77773770982E-02 3.86460233364E-02 3.95323391012E-02 4.04365641763E-02 4.13589348886E-02 4.22996836199E-02 4.32590382936E-02 4.42372218335E-02 4.52344515960E-02 4.62509387731E-02 4.72868877663E-02 4.83424955309E-02 4.94179508891E-02 5.05134338115E-02 5.16291146673E-02 5.27651534405E-02 5.39216989142E-02 5.50988878194E-02 5.62968439511E-02 5.75156772489E-02 5.87554828426E-02 6.00163400639E-02 6.12983114212E-02 6.26014415415E-02 6.39257560758E-02 6.52712605712E-02 6.66379393092E-02 6.80257541104E-02 6.94346431079E-02 7.08645194891E-02 7.23152702091E-02 7.37867546750E-02 7.52788034061E-02 7.67912166691E-02 7.83237630936E-02 7.98761782688E-02 8.14481633264E-02 8.30393835121E-02 8.46494667502E-02 8.62780022066E-02 8.79245388536E-02 8.95885840437E-02 9.12696020969E-02 9.29670129095E-02 9.46801905892E-02 9.64084621265E-02 9.81511061085E-02 9.99073514846E-02 1.01676376394E-01 1.03457307062E-01 1.05249216780E-01 1.07051124973E-01 1.08861996379E-01 1.10680740330E-01 1.12506210173E-01 1.14337202825E-01 1.16172458485E-01 1.18010660504E-01 1.19850435449E-01 1.21690353352E-01 1.23528928170E-01 1.25364618468E-01 1.27195828339E-01 1.29020908574E-01 1.30838158095E-01 1.32645825660E-01 1.34442111867E-01 1.36225171445E-01 1.37993115856E-01 1.39744016224E-01 1.41475906573E-01 1.43186787406E-01 1.44874629612E-01 1.46537378704E-01 1.48172959392E-01 1.49779280482E-01 1.51354240089E-01 1.52895731167E-01 1.54401647319E-01 1.55869888897E-01 1.57298369341E-01 1.58685021749E-01 1.60027805642E-01 1.61324713882E-01 1.62573779715E-01 1.63773083881E-01 1.64920761746E-01 1.66015010410E-01 1.67054095719E-01 1.68036359121E-01 1.68960224309E-01 1.69824203566E-01 1.70626903746E-01 1.71367031813E-01 1.72043399858E-01 1.72654929511E-01 1.73200655672E-01 1.73679729477E-01 1.74091420413E-01 1.74435117519E-01 1.74710329582E-01 1.74916684267E-01 1.75053926116E-01 1.75121913352E-01 1.75120613449E-01 1.75050097421E-01 1.74910532806E-01 1.74702175332E-01 1.74425359260E-01 1.74080486428E-01 1.73668014035E-01 1.73188441212E-01 1.72642294468E-01 1.72030112113E-01 1.71352427800E-01 1.70609753325E-01 1.69802560915E-01 1.68931265199E-01 1.67996205150E-01 1.66997626294E-01 1.65935663534E-01 1.64810324972E-01 1.63621477157E-01 1.62368832227E-01 1.61051937440E-01 1.59670167621E-01 1.58222721083E-01 1.56708619564E-01 1.55126712716E-01 1.53475687647E-01 1.51754083941E-01 1.49960314447E-01 1.48092691994E-01 1.46149461934E-01 1.44128840123E-01 1.42029055567E-01 1.39848396478E-01 1.37585257904E-01 1.35238188402E-01 1.32805932414E-01 1.30287464064E-01 1.27682007060E-01 1.24989034219E-01 1.22208238858E-01 1.19339471133E-01 1.16382658760E-01 1.13337783081E-01 1.10204878092E-01 1.06984031204E-01 1.03675383978E-01 1.00279132829E-01 9.67955297059E-02 9.32248827328E-02 8.95675568113E-02 8.58239741841E-02 8.19946149523E-02 7.80800175434E-02 7.40807791269E-02 6.99975559742E-02 6.58310637602E-02 6.15820778037E-02 5.72514332458E-02 5.28400251652E-02 4.83488086314E-02 4.37787986978E-02 3.91310703375E-02 3.44067583273E-02 2.96070570872E-02 2.47332204833E-02 1.97865616060E-02 1.47684525367E-02 9.68032411600E-03 4.52366573402E-03 -6.99974841972E-04 -5.98899157983E-03 -1.13417202142E-02 -1.67564381749E-02 -2.22313643897E-02 -2.77646589389E-02 -3.33544225405E-02 -3.89986958454E-02 -4.46954585272E-02 -5.04426281491E-02 -5.62380587994E-02 -6.20795394888E-02 -6.79647923073E-02 -7.38914703457E-02 -7.98571553925E-02 -8.58593554215E-02 -9.18955018953E-02 -9.79629469144E-02 -1.04058960249E-01 -1.10180726299E-01 -1.16325341028E-01 -1.22489808939E-01 -1.28671040137E-01 -1.34865847560E-01 -1.41070944444E-01 -1.47282942095E-01 -1.53498348037E-01 -1.59713564627E-01 -1.65924888198E-01 -1.72128508804E-01 -1.78320510651E-01 -1.84496873247E-01 -1.90653473366E-01 -1.96786087840E-01 -2.02890397239E-01 -2.08961990461E-01 -2.14996370242E-01 -2.20988959605E-01 -2.26935109212E-01 -2.32830105625E-01 -2.38669180408E-01 -2.44447520045E-01 -2.50160276589E-01 -2.55802578972E-01 -2.61369544892E-01 -2.66856293177E-01 -2.72257956515E-01 -2.77569694453E-01 -2.82786706541E-01 -2.87904245513E-01 -2.92917630385E-01 -2.97822259366E-01 -3.02613622471E-01 -3.07287313745E-01 -3.11839042993E-01 -3.16264646947E-01 -3.20560099795E-01 -3.24721523011E-01 -3.28745194430E-01 -3.32627556545E-01 -3.36365223985E-01 -3.39954990164E-01 -3.43393833094E-01 -3.46678920364E-01 -3.49807613302E-01 -3.52777470326E-01 -3.55586249528E-01 -3.58231910504E-01 -3.60712615481E-01 -3.63026729771E-01 -3.65172821591E-01 -3.67149661307E-01 -3.68956220134E-01 -3.70591668341E-01 -3.72055373004E-01 -3.73346895363E-01 -3.74465987808E-01 -3.75412590547E-01 -3.76186828001E-01 -3.76789004947E-01 -3.77219602465E-01 -3.77479273703E-01 -3.77568839514E-01 -3.77489283966E-01 -3.77241749783E-01 -3.76827533708E-01 -3.76248081845E-01 -3.75504984967E-01 -3.74599973831E-01 -3.73534914505E-01 -3.72311803725E-01 -3.70932764288E-01 -3.69400040497E-01 -3.67715993670E-01 -3.65883097705E-01 -3.63903934723E-01 -3.61781190783E-01 -3.59517651678E-01 -3.57116198812E-01 -3.54579805150E-01 -3.51911531257E-01 -3.49114521414E-01 -3.46191999806E-01 -3.43147266790E-01 -3.39983695231E-01 -3.36704726901E-01 -3.33313868945E-01 -3.29814690395E-01 -3.26210818740E-01 -3.22505936534E-01 -3.18703778042E-01 -3.14808125917E-01 -3.10822807893E-01 -3.06751693498E-01 -3.02598690769E-01 -2.98367742968E-01 -2.94062825288E-01 -2.89687941544E-01 -2.85247120834E-01 -2.80744414174E-01 -2.76183891094E-01 -2.71569636184E-01 -2.66905745592E-01 -2.62196323464E-01 -2.57445478317E-01 -2.52657319350E-01 -2.47835952678E-01 -2.42985477493E-01 -2.38109982145E-01 -2.33213540147E-01 -2.28300206092E-01 -2.23374011497E-01 -2.18438960560E-01 -2.13499025837E-01 -2.08558713732E-01 -2.03627612148E-01 -1.98709687959E-01 -1.93808274210E-01 -1.88926686922E-01 -1.84068219104E-01 -1.79236134735E-01 -1.74433662759E-01 -1.69663991088E-01 -1.64930260637E-01 -1.60235559411E-01 -1.55582916668E-01 -1.50975297160E-01 -1.46415595490E-01 -1.41906630594E-01 -1.37451140361E-01 -1.33051776429E-01 -1.28711099150E-01 -1.24431572766E-01 -1.20215560796E-01 -1.16065321664E-01 -1.11983004569E-01 -1.07970645635E-01 -1.04030164333E-01 -1.00163360208E-01 -9.63719099075E-02 -9.26573645435E-02 -8.90211473775E-02 -8.54645518549E-02 -8.19887399906E-02 -7.85947411133E-02 -7.52834509759E-02 -7.20556312354E-02 -6.89119093062E-02 -6.58527785878E-02 -6.28785990660E-02 -5.99895982876E-02 -5.71858727038E-02 -5.44673893777E-02 -5.18339880501E-02 -4.92853835542E-02 -4.68211685705E-02 -4.44408167100E-02 -4.21436859134E-02 -3.99290221515E-02 -3.77959634120E-02 -3.57435439550E-02 -3.37706988195E-02 -3.18762685620E-02 -3.00590042060E-02 -2.83175723825E-02 -2.66505606378E-02 -2.50564828880E-02 -2.35337849955E-02 -2.20808504444E-02 -2.06960060908E-02 -1.93775279640E-02 -1.81236470954E-02 -1.69325553496E-02 -1.58024112358E-02 -1.47313456753E-02 -1.37174677039E-02 -1.27588700857E-02 -1.18536348193E-02 -1.09998385153E-02 -1.01955576272E-02 -9.43887351756E-03 -8.72787734471E-03 -8.06067475389E-03 -7.43539036126E-03 -6.85017201921E-03 -6.30319485354E-03 -5.79266506542E-03 -5.31682349264E-03 -4.87394892687E-03 -4.46236118597E-03 -4.08042394254E-03 -3.72654731242E-03 -3.39919020912E-03 -3.09686247324E-03 -2.81812678827E-03 -2.56160039740E-03 -2.32595663925E-03 -2.10992632372E-03 -1.91229897317E-03 -1.73192395844E-03 -1.56771156399E-03 -1.41863402201E-03 -1.28372656182E-03 -1.15977424384E-03 -1.04607888683E-03 -9.41969010590E-04 -8.46800371067E-04 -7.59956334433E-04 -6.80848097591E-04 -6.08914762890E-04 -5.43623275592E-04 -4.84468233039E-04 -4.30971574923E-04 -3.82682164298E-04 -3.39175269213E-04 -3.00051954948E-04 -2.64938396817E-04 -2.33485123489E-04 -2.05366200580E-04 -1.80278364081E-04 -1.57940112866E-04 -1.38090769198E-04 -1.20489515720E-04 -1.04914416965E-04 -9.11614329459E-05 -7.90434318142E-05 -6.83892080658E-05 -5.90425121724E-05 -5.08610969470E-05 -4.37157853645E-05 -3.74895639752E-05 -3.20767054769E-05 -2.73819234501E-05 -2.33195617245E-05 -1.98128203249E-05 -1.67930194592E-05 -1.41989025523E-05 -1.19759789033E-05 -1.00759061549E-05 -8.45591240915E-06 -7.07825750657E-06 -5.90973270565E-06 -4.92119775590E-06 -4.08715415071E-06 -3.38535317291E-06 -2.79643720661E-06 -2.30361268060E-06 -1.89235292965E-06 -1.55012920811E-06 -1.26616806319E-06 -1.03123327011E-06 -8.37430545925E-07 -6.78033290912E-07 -5.47327652503E-07 -4.40475265948E-07 -3.53392094484E-07 -2.82641868607E-07 -2.25342706598E-07 -1.79085585102E-07 -1.41863417566E-07 -1.12009588256E-07 -8.81448791217E-08 -6.91318147976E-08 -5.40355366231E-08 -4.20903989617E-08 -3.26715596630E-08 -2.52709108106E-08 -1.94767655884E-08 -1.49567819688E-08 -1.14436638899E-08 -8.72323562176E-09 -6.62453520361E-09 -5.01161829770E-09 -3.77680473172E-09 -2.83513662903E-09 -2.11984960217E-09 -1.57868729311E-09 -1.17091487181E-09 -8.64909245476E-10 -6.36222978698E-10 -4.66035561808E-10 -3.39919968068E-10 -2.46864667785E-10 -1.78501664145E-10 -1.28499906906E-10 -9.20908336355E-11 -6.56989722456E-11 2.75942103910E-08 2.82927612923E-08 2.90089961010E-08 2.97433624876E-08 3.04963194558E-08 3.12683376287E-08 3.20598995434E-08 3.28714999526E-08 3.37036461335E-08 3.45568582055E-08 3.54316694546E-08 3.63286266671E-08 3.72482904714E-08 3.81912356880E-08 3.91580516895E-08 4.01493427683E-08 4.11657285147E-08 4.22078442038E-08 4.32763411931E-08 4.43718873292E-08 4.54951673654E-08 4.66468833895E-08 4.78277552631E-08 4.90385210709E-08 5.02799375825E-08 5.15527807252E-08 5.28578460693E-08 5.41959493249E-08 5.55679268518E-08 5.69746361828E-08 5.84169565590E-08 5.98957894798E-08 6.14120592664E-08 6.29667136389E-08 6.45607243098E-08 6.61950875900E-08 6.78708250129E-08 6.95889839717E-08 7.13506383749E-08 7.31568893171E-08 7.50088657673E-08 7.69077252749E-08 7.88546546926E-08 8.08508709187E-08 8.28976216575E-08 8.49961861993E-08 8.71478762199E-08 8.93540366006E-08 9.16160462685E-08 9.39353190587E-08 9.63133045980E-08 9.87514892106E-08 1.01251396848E-07 1.03814590039E-07 1.06442670872E-07 1.09137281989E-07 1.11900107617E-07 1.14732874621E-07 1.17637353581E-07 1.20615359899E-07 1.23668754936E-07 1.26799447172E-07 1.30009393404E-07 1.33300599963E-07 1.36675123970E-07 1.40135074627E-07 1.43682614527E-07 1.47319961011E-07 1.51049387554E-07 1.54873225183E-07 1.58793863937E-07 1.62813754358E-07 1.66935409027E-07 1.71161404129E-07 1.75494381068E-07 1.79937048116E-07 1.84492182105E-07 1.89162630163E-07 1.93951311497E-07 1.98861219212E-07 2.03895422185E-07 2.09057066985E-07 2.14349379835E-07 2.19775668633E-07 2.25339325018E-07 2.31043826488E-07 2.36892738576E-07 2.42889717081E-07 2.49038510346E-07 2.55342961607E-07 2.61807011395E-07 2.68434699993E-07 2.75230169971E-07 2.82197668767E-07 2.89341551346E-07 2.96666282922E-07 3.04176441745E-07 3.11876721971E-07 3.19771936588E-07 3.27867020427E-07 3.36167033249E-07 3.44677162906E-07 3.53402728581E-07 3.62349184119E-07 3.71522121429E-07 3.80927273985E-07 3.90570520408E-07 4.00457888139E-07 4.10595557207E-07 4.20989864096E-07 4.31647305699E-07 4.42574543384E-07 4.53778407158E-07 4.65265899933E-07 4.77044201904E-07 4.89120675043E-07 5.01502867690E-07 5.14198519283E-07 5.27215565188E-07 5.40562141660E-07 5.54246590935E-07 5.68277466435E-07 5.82663538124E-07 5.97413797983E-07 6.12537465636E-07 6.28043994108E-07 6.43943075741E-07 6.60244648245E-07 6.76958900914E-07 6.94096280996E-07 7.11667500224E-07 7.29683541507E-07 7.48155665801E-07 7.67095419147E-07 7.86514639886E-07 8.06425466064E-07 8.26840343014E-07 8.47772031139E-07 8.69233613891E-07 8.91238505944E-07 9.13800461586E-07 9.36933583311E-07 9.60652330640E-07 9.84971529158E-07 1.00990637978E-06 1.03547246826E-06 1.06168577493E-06 1.08856268468E-06 1.11611999722E-06 1.14437493758E-06 1.17334516685E-06 1.20304879326E-06 1.23350438348E-06 1.26473097423E-06 1.29674808417E-06 1.32957572612E-06 1.36323441957E-06 1.39774520350E-06 1.43312964953E-06 1.46940987542E-06 1.50660855888E-06 1.54474895177E-06 1.58385489461E-06 1.62395083151E-06 1.66506182544E-06 1.70721357389E-06 1.75043242496E-06 1.79474539382E-06 1.84018017959E-06 1.88676518268E-06 1.93452952253E-06 1.98350305581E-06 2.03371639513E-06 2.08520092813E-06 2.13798883711E-06 2.19211311919E-06 2.24760760690E-06 2.30450698938E-06 2.36284683400E-06 2.42266360868E-06 2.48399470464E-06 2.54687845978E-06 2.61135418269E-06 2.67746217719E-06 2.74524376756E-06 2.81474132436E-06 2.88599829094E-06 2.95905921060E-06 3.03396975443E-06 3.11077674991E-06 3.18952821015E-06 3.27027336395E-06 3.35306268655E-06 3.43794793124E-06 3.52498216167E-06 3.61421978509E-06 3.70571658635E-06 3.79952976280E-06 3.89571796003E-06 3.99434130859E-06 4.09546146158E-06 4.19914163322E-06 4.30544663835E-06 4.41444293303E-06 4.52619865607E-06 4.64078367164E-06 4.75826961302E-06 4.87872992734E-06 5.00223992158E-06 5.12887680966E-06 5.25871976072E-06 5.39184994867E-06 5.52835060299E-06 5.66830706073E-06 5.81180681998E-06 5.95893959454E-06 6.10979737011E-06 6.26447446178E-06 6.42306757309E-06 6.58567585653E-06 6.75240097554E-06 6.92334716816E-06 7.09862131227E-06 7.27833299241E-06 7.46259456842E-06 7.65152124571E-06 7.84523114737E-06 8.04384538812E-06 8.24748815005E-06 8.45628676042E-06 8.67037177128E-06 8.88987704124E-06 9.11493981923E-06 9.34570083041E-06 9.58230436427E-06 9.82489836496E-06 1.00736345239E-05 1.03286683748E-05 1.05901593909E-05 1.08582710849E-05 1.11331711115E-05 1.14150313721E-05 1.17040281225E-05 1.20003420836E-05 1.23041585541E-05 1.26156675269E-05 1.29350638079E-05 1.32625471380E-05 1.35983223186E-05 1.39425993392E-05 1.42955935098E-05 1.46575255948E-05 1.50286219524E-05 1.54091146754E-05 1.57992417374E-05 1.61992471415E-05 1.66093810733E-05 1.70299000580E-05 1.74610671206E-05 1.79031519513E-05 1.83564310741E-05 1.88211880207E-05 1.92977135078E-05 1.97863056195E-05 2.02872699943E-05 2.08009200167E-05 2.13275770138E-05 2.18675704568E-05 2.24212381675E-05 2.29889265305E-05 2.35709907104E-05 2.41677948746E-05 2.47797124217E-05 2.54071262163E-05 2.60504288287E-05 2.67100227816E-05 2.73863208028E-05 2.80797460842E-05 2.87907325478E-05 2.95197251177E-05 3.02671800000E-05 3.10335649690E-05 3.18193596614E-05 3.26250558774E-05 3.34511578896E-05 3.42981827601E-05 3.51666606658E-05 3.60571352308E-05 3.69701638692E-05 3.79063181347E-05 3.88661840808E-05 3.98503626287E-05 4.08594699460E-05 4.18941378340E-05 4.29550141252E-05 4.40427630914E-05 4.51580658616E-05 4.63016208510E-05 4.74741442005E-05 4.86763702284E-05 4.99090518923E-05 5.11729612639E-05 5.24688900157E-05 5.37976499197E-05 5.51600733595E-05 5.65570138550E-05 5.79893466011E-05 5.94579690195E-05 6.09638013253E-05 6.25077871078E-05 6.40908939260E-05 6.57141139202E-05 6.73784644383E-05 6.90849886786E-05 7.08347563494E-05 7.26288643452E-05 7.44684374403E-05 7.63546290002E-05 7.82886217119E-05 8.02716283319E-05 8.23048924545E-05 8.43896892991E-05 8.65273265187E-05 8.87191450279E-05 9.09665198540E-05 9.32708610082E-05 9.56336143808E-05 9.80562626587E-05 1.00540326267E-04 1.03087364335E-04 1.05698975685E-04 1.08376799853E-04 1.11122518126E-04 1.13937854616E-04 1.16824577357E-04 1.19784499428E-04 1.22819480111E-04 1.25931426074E-04 1.29122292591E-04 1.32394084785E-04 1.35748858909E-04 1.39188723662E-04 1.42715841535E-04 1.46332430192E-04 1.50040763892E-04 1.53843174942E-04 1.57742055194E-04 1.61739857575E-04 1.65839097661E-04 1.70042355293E-04 1.74352276232E-04 1.78771573857E-04 1.83303030916E-04 1.87949501309E-04 1.92713911933E-04 1.97599264560E-04 2.02608637781E-04 2.07745188987E-04 2.13012156410E-04 2.18412861219E-04 2.23950709662E-04 2.29629195278E-04 2.35451901159E-04 2.41422502270E-04 2.47544767841E-04 2.53822563813E-04 2.60259855351E-04 2.66860709428E-04 2.73629297475E-04 2.80569898102E-04 2.87686899889E-04 2.94984804262E-04 3.02468228430E-04 3.10141908416E-04 3.18010702164E-04 3.26079592723E-04 3.34353691529E-04 3.42838241766E-04 3.51538621825E-04 3.60460348849E-04 3.69609082382E-04 3.78990628112E-04 3.88610941718E-04 3.98476132820E-04 4.08592469041E-04 4.18966380176E-04 4.29604462475E-04 4.40513483048E-04 4.51700384388E-04 4.63172289017E-04 4.74936504262E-04 4.87000527168E-04 4.99372049536E-04 5.12058963112E-04 5.25069364912E-04 5.38411562702E-04 5.52094080626E-04 5.66125664995E-04 5.80515290234E-04 5.95272165003E-04 6.10405738483E-04 6.25925706844E-04 6.41842019895E-04 6.58164887923E-04 6.74904788725E-04 6.92072474839E-04 7.09678980988E-04 7.27735631730E-04 7.46254049330E-04 7.65246161860E-04 7.84724211533E-04 8.04700763271E-04 8.25188713535E-04 8.46201299396E-04 8.67752107882E-04 8.89855085595E-04 9.12524548608E-04 9.35775192654E-04 9.59622103618E-04 9.84080768331E-04 1.00916708570E-03 1.03489737815E-03 1.06128840341E-03 1.08835736669E-03 1.11612193314E-03 1.14460024079E-03 1.17381091379E-03 1.20377307608E-03 1.23450636554E-03 1.26603094844E-03 1.29836753444E-03 1.33153739205E-03 1.36556236446E-03 1.40046488600E-03 1.43626799899E-03 1.47299537121E-03 1.51067131385E-03 1.54932080001E-03 1.58896948388E-03 1.62964372042E-03 1.67137058571E-03 1.71417789793E-03 1.75809423903E-03 1.80314897708E-03 1.84937228932E-03 1.89679518600E-03 1.94544953495E-03 1.99536808693E-03 2.04658450188E-03 2.09913337596E-03 2.15305026950E-03 2.20837173587E-03 2.26513535131E-03 2.32337974576E-03 2.38314463465E-03 2.44447085187E-03 2.50740038375E-03 2.57197640419E-03 2.63824331105E-03 2.70624676371E-03 2.77603372189E-03 2.84765248589E-03 2.92115273813E-03 2.99658558612E-03 3.07400360700E-03 3.15346089348E-03 3.23501310154E-03 3.31871749969E-03 3.40463301998E-03 3.49282031084E-03 3.58334179171E-03 3.67626170972E-03 3.77164619828E-03 3.86956333784E-03 3.97008321873E-03 4.07327800640E-03 4.17922200886E-03 4.28799174669E-03 4.39966602549E-03 4.51432601107E-03 4.63205530728E-03 4.75294003677E-03 4.87706892472E-03 5.00453338560E-03 5.13542761320E-03 5.26984867401E-03 5.40789660398E-03 5.54967450905E-03 5.69528866927E-03 5.84484864702E-03 5.99846739910E-03 6.15626139325E-03 6.31835072894E-03 6.48485926281E-03 6.65591473888E-03 6.83164892371E-03 7.01219774673E-03 7.19770144596E-03 7.38830471936E-03 7.58415688189E-03 7.78541202879E-03 7.99222920505E-03 8.20477258145E-03 8.42321163754E-03 8.64772135155E-03 8.87848239788E-03 9.11568135215E-03 9.35951090431E-03 9.61017008006E-03 9.86786447100E-03 1.01328064737E-02 1.04052155381E-02 1.06853184260E-02 1.09733494793E-02 1.12695508988E-02 1.15741730344E-02 1.18874746863E-02 1.22097234179E-02 1.25411958820E-02 1.28821781584E-02 1.32329661060E-02 1.35938657282E-02 1.39651935525E-02 1.43472770258E-02 1.47404549245E-02 1.51450777808E-02 1.55615083261E-02 1.59901219515E-02 1.64313071861E-02 1.68854661950E-02 1.73530152950E-02 1.78343854923E-02 1.83300230395E-02 1.88403900154E-02 1.93659649262E-02 1.99072433310E-02 2.04647384900E-02 2.10389820393E-02 2.16305246894E-02 2.22399369525E-02 2.28678098953E-02 2.35147559221E-02 2.41814095858E-02 2.48684284305E-02 2.55764938645E-02 2.63063120660E-02 2.70586149229E-02 2.78341610052E-02 2.86337365748E-02 2.94581566303E-02 3.03082659899E-02 3.11849404126E-02 3.20890877591E-02 3.30216491932E-02 3.39836004245E-02 3.49759529944E-02 3.59997556052E-02 3.70560954936E-02 3.81460998504E-02 3.92709372860E-02 4.04318193436E-02 4.16300020603E-02 4.28667875771E-02 4.41435257988E-02 4.54616161035E-02 4.68225091034E-02 4.82277084567E-02 4.96787727303E-02 5.11773173157E-02 5.27250163951E-02 5.43236049603E-02 5.59748808825E-02 5.76807070339E-02 5.94430134586E-02 6.12637995946E-02 6.31451365428E-02 6.50891693846E-02 6.70981195439E-02 6.91742871935E-02 7.13200537028E-02 7.35378841237E-02 7.58303297125E-02 7.82000304846E-02 8.06497177965E-02 8.31822169523E-02 8.58004498295E-02 8.85074375177E-02 9.13063029651E-02 9.42002736258E-02 9.71926841003E-02 1.00286978761E-01 1.03486714356E-01 1.06795562574E-01 1.10217312574E-01 1.13755873451E-01 1.17415276641E-01 1.21199678240E-01 1.25113361229E-01 1.29160737591E-01 1.33346350295E-01 1.37674875139E-01 1.42151122428E-01 1.46780038465E-01 1.51566706840E-01 1.56516349484E-01 1.61634327477E-01 1.66926141576E-01 1.72397432428E-01 1.78053980466E-01 1.83901705425E-01 1.89946665476E-01 1.96195055924E-01 2.02653207454E-01 2.09327583872E-01 2.16224779322E-01 2.23351514929E-01 2.30714634838E-01 2.38321101602E-01 2.46177990890E-01 2.54292485459E-01 2.62671868363E-01 2.71323515350E-01 2.80254886410E-01 2.89473516426E-01 2.98987004897E-01 3.08803004685E-01 3.18929209751E-01 3.29373341847E-01 3.40143136123E-01 3.51246325616E-01 3.62690624605E-01 3.74483710786E-01 3.86633206261E-01 3.99146657324E-01 4.12031513014E-01 4.25295102457E-01 4.38944610970E-01 4.52987054958E-01 4.67429255595E-01 4.82277811336E-01 4.97539069273E-01 5.13219095385E-01 5.29323643732E-01 5.45858124650E-01 5.62827572022E-01 5.80236609702E-01 5.98089417192E-01 6.16389694663E-01 6.35140627444E-01 6.54344850094E-01 6.74004410201E-01 6.94120732027E-01 7.14694580168E-01 7.35726023382E-01 7.57214398721E-01 7.79158276155E-01 8.01555423836E-01 8.24402774162E-01 8.47696390795E-01 8.71431436782E-01 8.95602143910E-01 9.20201783423E-01 9.45222638195E-01 9.70655976443E-01 9.96492027037E-01 1.02271995643E+00 1.04932784722E+00 1.07630267826E+00 1.10363030628E+00 1.13129544893E+00 1.15928166898E+00 1.18757135958E+00 1.21614573037E+00 1.24498479403E+00 1.27406735311E+00 1.30337098678E+00 1.33287203711E+00 1.36254559465E+00 1.39236548281E+00 1.42230424099E+00 1.45233310589E+00 1.48242199110E+00 1.51253946464E+00 1.54265272463E+00 1.57272757307E+00 1.60272838822E+00 1.63261809589E+00 1.66235814054E+00 1.69190845710E+00 1.72122744462E+00 1.75027194352E+00 1.77899721801E+00 1.80735694589E+00 1.83530321817E+00 1.86278655103E+00 1.88975591315E+00 1.91615877146E+00 1.94194115844E+00 1.96704776431E+00 1.99142205737E+00 2.01500643528E+00 2.03774241035E+00 2.05957083077E+00 2.08043213971E+00 2.10026667313E+00 2.11901499613E+00 2.13661827692E+00 2.15301869599E+00 2.16815988660E+00 2.18198740178E+00 2.19444920085E+00 2.20549614765E+00 2.21508251087E+00 2.22316645571E+00 2.22971051536E+00 2.23468202959E+00 2.23805353789E+00 2.23980311445E+00 2.23991463293E+00 2.23837795032E+00 2.23518900057E+00 2.23034979151E+00 2.22386830081E+00 2.21575827059E+00 2.20603890348E+00 2.19473446721E+00 2.18187381870E+00 2.16748986286E+00 2.15161896522E+00 2.13430034168E+00 2.11557545202E+00 2.09548742798E+00 2.07408056967E+00 2.05139994815E+00 2.02749115521E+00 2.00240024527E+00 1.97617391770E+00 1.94885997336E+00 1.92050786136E+00 1.89116874139E+00 1.86089534864E+00 1.82974183978E+00 1.79776363526E+00 1.76501725833E+00 1.73156017157E+00 1.69745061142E+00 1.66274742122E+00 1.62750988366E+00 1.59179755289E+00 1.55567008720E+00 1.51918708265E+00 1.48240790839E+00 1.44539154416E+00 1.40819642066E+00 1.37088026323E+00 1.33349993951E+00 1.29611131158E+00 1.25876909316E+00 1.22152671230E+00 1.18443618024E+00 1.14754796679E+00 1.11091088275E+00 1.07457196986E+00 1.03857639872E+00 1.00296737503E+00 9.67786054594E-01 9.33071467413E-01 8.98860451180E-01 8.65187594429E-01 8.32085189575E-01 7.99583195991E-01 7.67709213253E-01 7.36488464562E-01 7.05943790343E-01 6.76095651923E-01 6.46962145109E-01 6.18559023437E-01 5.90899730775E-01 5.63995442895E-01 5.37855117563E-01 5.12485552619E-01 4.87891451489E-01 4.64075495484E-01 4.41038422230E-01 4.18779109510E-01 3.97294663793E-01 3.76580512704E-01 3.56630500675E-01 3.37436987032E-01 3.18990945775E-01 3.01282066337E-01 2.84298854628E-01 2.68028733726E-01 2.52458143584E-01 2.37572639213E-01 2.23356986817E-01 2.09795257423E-01 1.96870917625E-01 1.84566917070E-01 1.72865772427E-01 1.61749647598E-01 1.51200429996E-01 1.41199802766E-01 1.31729312868E-01 1.22770435008E-01 1.14304631390E-01 1.06313407366E-01 9.87783630300E-02 9.16812408668E-02 8.50039695642E-02 7.87287041277E-02 7.28378624374E-02 6.73141583994E-02 6.21406318472E-02 5.73006753468E-02 5.27780580590E-02 4.85569468071E-02 4.46219244939E-02 4.09580060013E-02 3.75506517044E-02 3.43857787182E-02 3.14497699924E-02 2.87294813615E-02 2.62122466519E-02 2.38858809415E-02 2.17386820673E-02 1.97594304693E-02 1.79373874605E-02 1.62622920105E-02 1.47243561309E-02 1.33142589507E-02 1.20231395717E-02 1.08425887937E-02 9.76463980271E-03 8.78175791421E-03 7.88682946656E-03 7.07314995878E-03 6.33441152753E-03 5.66468985772E-03 5.05843061986E-03 4.51043552567E-03 4.01584809105E-03 3.57013919267E-03 3.16909250079E-03 2.80878986682E-03 2.48559673989E-03 2.19614768149E-03 1.93733204234E-03 1.70627985983E-03 1.50034802936E-03 1.31710679663E-03 1.15432661273E-03 1.00996538800E-03 8.82156175374E-04 7.69195308334E-04 6.69531013713E-04 5.81752514719E-04 5.04579634898E-04 4.36852909602E-04 3.77524207587E-04 3.25647861769E-04 2.80372304951E-04 2.40932203444E-04 2.06641078918E-04 1.76884406637E-04 1.51113176295E-04 1.28837900074E-04 1.09623051239E-04 9.30819155210E-05 7.88718367754E-05 6.66898377949E-05 5.62685968516E-05 4.73727603481E-05 3.97955719849E-05 3.33557990071E-05 2.78949363942E-05 2.32746702634E-05 1.93745822729E-05 1.60900773998E-05 1.33305181304E-05 1.10175488148E-05 9.08359469276E-06 7.47052088448E-06 6.12843744085E-06 5.01463736562E-06 4.09265533297E-06 3.33143563429E-06 2.70459868288E-06 2.18979618239E-06 1.76814581916E-06 1.42373706556E-06 1.14320037856E-06 9.15332742134E-07 7.30773132326E-07 5.81722078074E-07 4.61700049070E-07 3.65339923338E-07 2.88209272189E-07 2.26658649213E-07 1.77692483795E-07 1.38860319285E-07 1.08169065483E-07 8.39900280843E-08 6.50029841357E-08 5.01418991241E-08 3.85488104798E-08 2.95355121417E-08 2.25518282048E-08 1.71594326415E-08 1.30103207446E-08 9.82916822133E-09 7.39892759964E-09 5.54911050142E-09 4.14628997379E-09 3.08643093452E-09 2.28872022993E-09 1.69062207045E-09 1.24393083106E-09 9.11632406544E-10 6.65418417892E-10 4.83725402430E-10 3.50194423069E-10 2.52465952826E-10 1.81241003815E-10 1.29552777977E-10 9.22040580292E-11 6.53345107448E-11 4.60893676619E-11 3.23668606277E-11 2.26265597836E-11 1.57445917976E-11 1.09047766533E-11 7.51715477389E-12 5.15730158129E-12 3.52134223946E-12 2.39276645093E-12 1.61806822300E-12 1.08895263431E-12 7.29404653339E-13 4.86339291406E-13 3.22876075081E-13 2.13526403330E-13 1.40768304910E-13 9.26210919745E-14 6.09378113989E-14 3.98700912767E-14 2.59394285523E-14 1.67801319223E-14 1.07924672729E-14 6.90088410907E-15 4.38647015014E-15 2.77152946074E-15 1.74054284460E-15 1.08636920153E-15 6.73850994476E-16 4.15345755812E-16 2.54378557707E-16 1.54789307565E-16 9.35740921991E-17 5.61938162383E-17 3.35199415215E-17 1.98592537489E-17 1.16850401847E-17 6.82758799951E-18 3.96128362467E-18 2.28190391427E-18 1.30500540856E-18 7.40868420496E-19 4.17487465640E-19 2.33495574216E-19 1.29600142190E-19 7.13809226529E-20 3.90091429902E-20 2.11502459677E-20 1.13759021737E-20 6.06923280712E-21 3.21155101223E-21 1.68532605053E-21 8.76991857058E-22 4.52484358921E-22 2.31452167640E-22 1.17360325379E-22 5.89842194319E-23 2.93803086837E-23 1.45021955537E-23 7.09281001390E-24 3.43684323745E-24 1.64970759185E-24 7.84347403904E-25 3.69327745050E-25 1.72212420098E-25 7.95083040089E-26 3.63414072737E-26 1.64428573705E-26 7.36348680271E-27 3.26335325736E-27 1.43107366050E-27 6.20896865621E-28 2.66488244572E-28 1.13130198776E-28 4.74964338255E-29 1.97180840495E-29 8.09334810202E-30 3.28389519782E-30 1.31699735563E-30 5.21976866598E-31 2.04420167175E-31 7.90927966618E-32 3.02290565600E-32 1.14108934018E-32 4.25357584392E-33 1.56552288815E-33 5.68808052710E-34 2.03987059047E-34 7.21935949795E-35 2.52105082332E-35 8.68516781007E-36 2.95130700572E-36 9.89042774379E-37 3.26816728075E-37 1.06464556693E-37 3.41853063477E-38 1.08175437783E-38 3.37281654933E-39 1.03597854765E-39 3.13415796742E-40 9.33727485453E-41 2.73882679206E-41 7.90804482518E-42 2.24723093717E-42 6.28366656181E-43 1.72853079571E-43 4.67681601483E-44 1.24434873190E-44 3.25507458014E-45 8.36977887307E-46 2.11498485604E-46 5.25104362415E-47 1.28065671260E-47 3.06740425635E-48 7.21376015996E-49 1.66534705531E-49 3.77310504000E-50 8.38767451148E-51 1.82906410684E-51 3.91161244234E-52 8.20192455680E-53 1.68578027987E-53 3.39548837709E-54 6.70052863015E-55 1.29511846808E-55 2.45126462947E-56 4.54188790924E-57 8.23629572010E-58 1.46136630978E-58 2.53628904144E-59 4.30457471998E-60 7.14219078872E-61 1.15818687293E-61 1.83504438034E-62 2.83993514419E-63 4.29176335431E-64 6.33138278579E-65 9.11517818566E-66 1.28027190543E-66 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1 1 1 1 0 N L 1S eig: -20.59439976 4.23214128948E-03 4.28532370382E-03 4.33917442506E-03 4.39370185134E-03 4.44891385573E-03 4.50481769765E-03 4.56142238530E-03 4.61873662681E-03 4.67676930689E-03 4.73552942076E-03 4.79502607585E-03 4.85526849317E-03 4.91626600697E-03 4.97802806825E-03 5.04056425028E-03 5.10388424387E-03 5.16799785701E-03 5.23291502192E-03 5.29864579406E-03 5.36520035354E-03 5.43258900744E-03 5.50082219123E-03 5.56991047024E-03 5.63986454102E-03 5.71069523343E-03 5.78241351198E-03 5.85503047713E-03 5.92855736753E-03 6.00300556196E-03 6.07838658041E-03 6.15471208578E-03 6.23199388604E-03 6.31024393611E-03 6.38947433929E-03 6.46969734931E-03 6.55092537210E-03 6.63317096767E-03 6.71644685200E-03 6.80076589898E-03 6.88614114228E-03 6.97258577733E-03 7.06011316333E-03 7.14873682542E-03 7.23847045645E-03 7.32932791900E-03 7.42132324785E-03 7.51447065177E-03 7.60878451573E-03 7.70427940302E-03 7.80097005728E-03 7.89887140501E-03 7.99799855779E-03 8.09836681412E-03 8.19999166211E-03 8.30288878181E-03 8.40707404732E-03 8.51256352933E-03 8.61937349742E-03 8.72752042254E-03 8.83702097942E-03 8.94789204910E-03 9.06015072138E-03 9.17381429743E-03 9.28890029230E-03 9.40542643757E-03 9.52341068393E-03 9.64287120389E-03 9.76382639444E-03 9.88629487981E-03 1.00102955142E-02 1.01358473845E-02 1.02629698133E-02 1.03916823615E-02 1.05220048314E-02 1.06539572696E-02 1.07875599698E-02 1.09228334759E-02 1.10597985851E-02 1.11984763507E-02 1.13388880855E-02 1.14810553648E-02 1.16250000294E-02 1.17707441891E-02 1.19183102258E-02 1.20677207966E-02 1.22189988375E-02 1.23721675664E-02 1.25272504866E-02 1.26842713905E-02 1.28432543624E-02 1.30042237827E-02 1.31672043312E-02 1.33322209905E-02 1.34992990500E-02 1.36684641090E-02 1.38397420811E-02 1.40131591974E-02 1.41887420106E-02 1.43665173989E-02 1.45465125693E-02 1.47287550623E-02 1.49132727555E-02 1.51000938674E-02 1.52892469618E-02 1.54807609519E-02 1.56746651042E-02 1.58709890428E-02 1.60697627537E-02 1.62710165890E-02 1.64747812713E-02 1.66810878982E-02 1.68899679464E-02 1.71014532765E-02 1.73155761372E-02 1.75323691702E-02 1.77518654149E-02 1.79740983125E-02 1.81991017112E-02 1.84269098712E-02 1.86575574687E-02 1.88910796017E-02 1.91275117944E-02 1.93668900022E-02 1.96092506170E-02 1.98546304722E-02 2.01030668475E-02 2.03545974748E-02 2.06092605428E-02 2.08670947028E-02 2.11281390735E-02 2.13924332471E-02 2.16600172945E-02 2.19309317708E-02 2.22052177206E-02 2.24829166842E-02 2.27640707027E-02 2.30487223246E-02 2.33369146113E-02 2.36286911426E-02 2.39240960230E-02 2.42231738877E-02 2.45259699087E-02 2.48325298007E-02 2.51428998277E-02 2.54571268090E-02 2.57752581254E-02 2.60973417259E-02 2.64234261341E-02 2.67535604544E-02 2.70877943792E-02 2.74261781947E-02 2.77687627885E-02 2.81155996556E-02 2.84667409060E-02 2.88222392707E-02 2.91821481098E-02 2.95465214183E-02 2.99154138344E-02 3.02888806457E-02 3.06669777972E-02 3.10497618980E-02 3.14372902291E-02 3.18296207509E-02 3.22268121101E-02 3.26289236481E-02 3.30360154081E-02 3.34481481433E-02 3.38653833239E-02 3.42877831461E-02 3.47154105389E-02 3.51483291730E-02 3.55866034683E-02 3.60302986024E-02 3.64794805187E-02 3.69342159345E-02 3.73945723500E-02 3.78606180558E-02 3.83324221421E-02 3.88100545072E-02 3.92935858660E-02 3.97830877586E-02 4.02786325595E-02 4.07802934859E-02 4.12881446074E-02 4.18022608542E-02 4.23227180268E-02 4.28495928048E-02 4.33829627562E-02 4.39229063468E-02 4.44695029495E-02 4.50228328538E-02 4.55829772751E-02 4.61500183644E-02 4.67240392180E-02 4.73051238874E-02 4.78933573885E-02 4.84888257120E-02 4.90916158332E-02 4.97018157216E-02 5.03195143518E-02 5.09448017125E-02 5.15777688177E-02 5.22185077164E-02 5.28671115031E-02 5.35236743279E-02 5.41882914075E-02 5.48610590351E-02 5.55420745915E-02 5.62314365551E-02 5.69292445133E-02 5.76355991728E-02 5.83506023702E-02 5.90743570836E-02 5.98069674428E-02 6.05485387406E-02 6.12991774435E-02 6.20589912033E-02 6.28280888679E-02 6.36065804922E-02 6.43945773499E-02 6.51921919443E-02 6.59995380197E-02 6.68167305728E-02 6.76438858641E-02 6.84811214292E-02 6.93285560904E-02 7.01863099679E-02 7.10545044917E-02 7.19332624128E-02 7.28227078150E-02 7.37229661264E-02 7.46341641308E-02 7.55564299798E-02 7.64898932040E-02 7.74346847248E-02 7.83909368662E-02 7.93587833662E-02 8.03383593889E-02 8.13298015356E-02 8.23332478569E-02 8.33488378642E-02 8.43767125415E-02 8.54170143567E-02 8.64698872736E-02 8.75354767634E-02 8.86139298159E-02 8.97053949516E-02 9.08100222327E-02 9.19279632752E-02 9.30593712594E-02 9.42044009420E-02 9.53632086673E-02 9.65359523781E-02 9.77227916271E-02 9.89238875883E-02 1.00139403067E-01 1.01369502513E-01 1.02614352028E-01 1.03874119380E-01 1.05148974012E-01 1.06439087051E-01 1.07744631322E-01 1.09065781357E-01 1.10402713403E-01 1.11755605435E-01 1.13124637166E-01 1.14509990051E-01 1.15911847306E-01 1.17330393910E-01 1.18765816616E-01 1.20218303963E-01 1.21688046280E-01 1.23175235698E-01 1.24680066160E-01 1.26202733423E-01 1.27743435073E-01 1.29302370526E-01 1.30879741042E-01 1.32475749728E-01 1.34090601547E-01 1.35724503321E-01 1.37377663742E-01 1.39050293376E-01 1.40742604668E-01 1.42454811948E-01 1.44187131436E-01 1.45939781246E-01 1.47712981391E-01 1.49506953786E-01 1.51321922254E-01 1.53158112524E-01 1.55015752238E-01 1.56895070951E-01 1.58796300134E-01 1.60719673172E-01 1.62665425370E-01 1.64633793947E-01 1.66625018039E-01 1.68639338699E-01 1.70676998892E-01 1.72738243495E-01 1.74823319294E-01 1.76932474980E-01 1.79065961146E-01 1.81224030279E-01 1.83406936758E-01 1.85614936849E-01 1.87848288691E-01 1.90107252295E-01 1.92392089535E-01 1.94703064134E-01 1.97040441658E-01 1.99404489502E-01 2.01795476883E-01 2.04213674820E-01 2.06659356126E-01 2.09132795389E-01 2.11634268962E-01 2.14164054937E-01 2.16722433138E-01 2.19309685092E-01 2.21926094015E-01 2.24571944790E-01 2.27247523943E-01 2.29953119618E-01 2.32689021556E-01 2.35455521068E-01 2.38252911002E-01 2.41081485724E-01 2.43941541077E-01 2.46833374357E-01 2.49757284278E-01 2.52713570935E-01 2.55702535771E-01 2.58724481537E-01 2.61779712253E-01 2.64868533169E-01 2.67991250720E-01 2.71148172481E-01 2.74339607124E-01 2.77565864367E-01 2.80827254926E-01 2.84124090461E-01 2.87456683525E-01 2.90825347506E-01 2.94230396569E-01 2.97672145598E-01 3.01150910133E-01 3.04667006305E-01 3.08220750770E-01 3.11812460641E-01 3.15442453414E-01 3.19111046900E-01 3.22818559143E-01 3.26565308343E-01 3.30351612777E-01 3.34177790715E-01 3.38044160331E-01 3.41951039616E-01 3.45898746287E-01 3.49887597688E-01 3.53917910697E-01 3.57990001624E-01 3.62104186106E-01 3.66260779001E-01 3.70460094280E-01 3.74702444909E-01 3.78988142740E-01 3.83317498383E-01 3.87690821091E-01 3.92108418626E-01 3.96570597136E-01 4.01077661015E-01 4.05629912771E-01 4.10227652880E-01 4.14871179646E-01 4.19560789050E-01 4.24296774597E-01 4.29079427160E-01 4.33909034820E-01 4.38785882701E-01 4.43710252800E-01 4.48682423816E-01 4.53702670970E-01 4.58771265826E-01 4.63888476102E-01 4.69054565482E-01 4.74269793418E-01 4.79534414930E-01 4.84848680405E-01 4.90212835383E-01 4.95627120344E-01 5.01091770489E-01 5.06607015518E-01 5.12173079397E-01 5.17790180124E-01 5.23458529491E-01 5.29178332842E-01 5.34949788814E-01 5.40773089093E-01 5.46648418142E-01 5.52575952945E-01 5.58555862728E-01 5.64588308684E-01 5.70673443690E-01 5.76811412022E-01 5.83002349052E-01 5.89246380957E-01 5.95543624410E-01 6.01894186266E-01 6.08298163248E-01 6.14755641620E-01 6.21266696863E-01 6.27831393335E-01 6.34449783932E-01 6.41121909739E-01 6.47847799681E-01 6.54627470159E-01 6.61460924686E-01 6.68348153519E-01 6.75289133277E-01 6.82283826562E-01 6.89332181565E-01 6.96434131677E-01 7.03589595080E-01 7.10798474346E-01 7.18060656023E-01 7.25376010212E-01 7.32744390146E-01 7.40165631758E-01 7.47639553245E-01 7.55165954626E-01 7.62744617295E-01 7.70375303564E-01 7.78057756212E-01 7.85791698014E-01 7.93576831276E-01 8.01412837359E-01 8.09299376201E-01 8.17236085835E-01 8.25222581894E-01 8.33258457127E-01 8.41343280893E-01 8.49476598665E-01 8.57657931523E-01 8.65886775642E-01 8.74162601784E-01 8.82484854777E-01 8.90852952996E-01 8.99266287845E-01 9.07724223227E-01 9.16226095017E-01 9.24771210537E-01 9.33358848021E-01 9.41988256083E-01 9.50658653183E-01 9.59369227097E-01 9.68119134375E-01 9.76907499811E-01 9.85733415909E-01 9.94595942346E-01 1.00349410544E+00 1.01242689764E+00 1.02139327694E+00 1.03039216644E+00 1.03942245373E+00 1.04848299046E+00 1.05757259174E+00 1.06669003571E+00 1.07583406298E+00 1.08500337615E+00 1.09419663932E+00 1.10341247761E+00 1.11264947666E+00 1.12190618219E+00 1.13118109954E+00 1.14047269320E+00 1.14977938637E+00 1.15909956057E+00 1.16843155520E+00 1.17777366711E+00 1.18712415030E+00 1.19648121544E+00 1.20584302959E+00 1.21520771584E+00 1.22457335297E+00 1.23393797517E+00 1.24329957173E+00 1.25265608681E+00 1.26200541917E+00 1.27134542195E+00 1.28067390248E+00 1.28998862212E+00 1.29928729609E+00 1.30856759336E+00 1.31782713657E+00 1.32706350194E+00 1.33627421925E+00 1.34545677184E+00 1.35460859665E+00 1.36372708425E+00 1.37280957899E+00 1.38185337906E+00 1.39085573675E+00 1.39981385857E+00 1.40872490560E+00 1.41758599367E+00 1.42639419379E+00 1.43514653246E+00 1.44383999212E+00 1.45247151162E+00 1.46103798671E+00 1.46953627064E+00 1.47796317475E+00 1.48631546911E+00 1.49458988330E+00 1.50278310710E+00 1.51089179138E+00 1.51891254896E+00 1.52684195554E+00 1.53467655068E+00 1.54241283889E+00 1.55004729073E+00 1.55757634400E+00 1.56499640494E+00 1.57230384960E+00 1.57949502515E+00 1.58656625135E+00 1.59351382205E+00 1.60033400674E+00 1.60702305221E+00 1.61357718425E+00 1.61999260946E+00 1.62626551702E+00 1.63239208072E+00 1.63836846085E+00 1.64419080635E+00 1.64985525691E+00 1.65535794516E+00 1.66069499903E+00 1.66586254403E+00 1.67085670575E+00 1.67567361234E+00 1.68030939708E+00 1.68476020108E+00 1.68902217598E+00 1.69309148675E+00 1.69696431461E+00 1.70063685994E+00 1.70410534530E+00 1.70736601858E+00 1.71041515610E+00 1.71324906586E+00 1.71586409088E+00 1.71825661250E+00 1.72042305389E+00 1.72235988346E+00 1.72406361850E+00 1.72553082873E+00 1.72675814002E+00 1.72774223810E+00 1.72847987234E+00 1.72896785960E+00 1.72920308810E+00 1.72918252134E+00 1.72890320208E+00 1.72836225635E+00 1.72755689745E+00 1.72648443010E+00 1.72514225445E+00 1.72352787027E+00 1.72163888106E+00 1.71947299822E+00 1.71702804520E+00 1.71430196168E+00 1.71129280774E+00 1.70799876803E+00 1.70441815590E+00 1.70054941758E+00 1.69639113625E+00 1.69194203613E+00 1.68720098656E+00 1.68216700596E+00 1.67683926584E+00 1.67121709463E+00 1.66529998157E+00 1.65908758046E+00 1.65257971332E+00 1.64577637400E+00 1.63867773169E+00 1.63128413429E+00 1.62359611169E+00 1.61561437895E+00 1.60733983930E+00 1.59877358700E+00 1.58991691013E+00 1.58077129311E+00 1.57133841912E+00 1.56162017228E+00 1.55161863973E+00 1.54133611341E+00 1.53077509169E+00 1.51993828073E+00 1.50882859569E+00 1.49744916159E+00 1.48580331400E+00 1.47389459940E+00 1.46172677538E+00 1.44930381039E+00 1.43662988337E+00 1.42370938296E+00 1.41054690647E+00 1.39714725852E+00 1.38351544930E+00 1.36965669264E+00 1.35557640360E+00 1.34128019585E+00 1.32677387859E+00 1.31206345325E+00 1.29715510977E+00 1.28205522259E+00 1.26677034655E+00 1.25130721134E+00 1.23567271735E+00 1.21987393002E+00 1.20391807420E+00 1.18781252821E+00 1.17156481757E+00 1.15518260853E+00 1.13867370129E+00 1.12204602301E+00 1.10530762057E+00 1.08846665321E+00 1.07153138490E+00 1.05451017671E+00 1.03741147894E+00 1.02024382331E+00 1.00301581501E+00 9.85736124903E-01 9.68413481682E-01 9.51056664251E-01 9.33674494252E-01 9.16275828869E-01 8.98869553960E-01 8.81464577577E-01 8.64069823942E-01 8.46694227927E-01 8.29346730061E-01 8.12036272062E-01 7.94771792832E-01 7.77562224793E-01 7.60416490352E-01 7.43343498187E-01 7.26352138897E-01 7.09451279454E-01 6.92649755766E-01 6.75956362547E-01 6.59379839674E-01 6.42928854236E-01 6.26611977669E-01 6.10437657648E-01 5.94414184900E-01 5.78549655615E-01 5.62851930801E-01 5.47328594509E-01 5.31986913312E-01 5.16833799678E-01 5.01875781793E-01 4.87118981989E-01 4.72569105250E-01 4.58231438291E-01 4.44110858702E-01 4.30211852627E-01 4.16538538635E-01 4.03094694982E-01 3.89883787369E-01 3.76908994635E-01 3.64173230451E-01 3.51679159887E-01 3.39429210525E-01 3.27425578490E-01 3.15670230198E-01 3.04164900916E-01 2.92911091205E-01 2.81910062270E-01 2.71162831036E-01 2.60670165544E-01 2.50432581122E-01 2.40450337548E-01 2.30723437355E-01 2.21251625307E-01 2.12034389009E-01 2.03070960611E-01 1.94360319503E-01 1.85901195920E-01 1.77692075382E-01 1.69731203861E-01 1.62016593613E-01 1.54546029609E-01 1.47317076489E-01 1.40327085995E-01 1.33573204834E-01 1.27052382924E-01 1.20761381988E-01 1.14696784468E-01 1.08855002709E-01 1.03232288410E-01 9.78247422852E-02 9.26283239336E-02 8.76388618701E-02 8.28520637003E-02 7.82635264077E-02 7.38687467259E-02 6.96631315641E-02 6.56420084592E-02 6.18006360219E-02 5.81342143470E-02 5.46378953570E-02 5.13067930488E-02 4.81359936111E-02 4.51205653857E-02 4.22555686390E-02 3.95360651191E-02 3.69571273684E-02 3.45138477656E-02 3.22013472729E-02 3.00147838647E-02 2.79493606152E-02 2.60003334253E-02 2.41630183711E-02 2.24327986573E-02 2.08051311606E-02 1.92755525525E-02 1.78396849908E-02 1.64932413712E-02 1.52320301344E-02 1.40519596251E-02 1.29490420009E-02 1.19193966911E-02 1.09592534106E-02 1.00649547302E-02 9.23295821226E-03 8.45983811930E-03 7.74228670488E-03 7.07711509939E-03 6.46125380329E-03 5.89175280244E-03 5.36578132122E-03 4.88062723034E-03 4.43369612718E-03 4.02251010728E-03 3.64470624656E-03 3.29803481405E-03 2.98035723575E-03 2.68964383024E-03 2.42397133698E-03 2.18152025826E-03 1.96057203565E-03 1.75950608163E-03 1.57679668669E-03 1.41100982187E-03 1.26079985614E-03 1.12490620738E-03 1.00214994494E-03 8.91430361249E-04 7.91721528836E-04 7.02068858292E-04 6.21585671854E-04 5.49449806201E-04 4.84900257096E-04 4.27233877449E-04 3.75802139342E-04 3.30007969512E-04 2.89302666740E-04 2.53182908562E-04 2.21187853714E-04 1.92896345722E-04 1.67924222110E-04 1.45921732767E-04 1.26571070132E-04 1.09584013036E-04 9.46996852425E-05 8.16824289877E-05 7.03197931533E-05 6.04206350641E-05 5.18133343346E-05 4.43441166710E-05 3.78754850753E-05 3.22847554922E-05 2.74626935915E-05 2.33122490801E-05 1.97473836938E-05 1.66919888258E-05 1.40788885982E-05 1.18489240804E-05 9.95011429949E-06 8.33688965938E-06 6.96939340268E-06 5.81284679016E-06 4.83697374679E-06 4.01548082034E-06 3.32558842274E-06 2.74760943113E-06 2.26457164205E-06 1.86187809169E-06 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 -1.20929865479E+01 -1.20943542933E+01 -1.20955142289E+01 -1.20964751234E+01 -1.20972459315E+01 -1.20978358010E+01 -1.20982765890E+01 -1.20983695538E+01 -1.20984760266E+01 -1.20984892394E+01 -1.20983361314E+01 -1.20980306797E+01 -1.20992022420E+01 -1.20984720937E+01 -1.20972631510E+01 -1.20963626789E+01 -1.20953445606E+01 -1.20943692053E+01 -1.20934341285E+01 -1.20926271825E+01 -1.20917799561E+01 -1.20909482430E+01 -1.20901488670E+01 -1.20893801696E+01 -1.20885251338E+01 -1.20878156530E+01 -1.20871300763E+01 -1.20864668352E+01 -1.20857242133E+01 -1.20851071095E+01 -1.20845084544E+01 -1.20839270988E+01 -1.20833620812E+01 -1.20828123890E+01 -1.20822772009E+01 -1.20817557182E+01 -1.20812471046E+01 -1.20807505850E+01 -1.20802655506E+01 -1.20797913884E+01 -1.20793652159E+01 -1.20789088729E+01 -1.20784618030E+01 -1.20780499675E+01 -1.20776282459E+01 -1.20772041833E+01 -1.20767877230E+01 -1.20763441663E+01 -1.20759438071E+01 -1.20755499068E+01 -1.20751298466E+01 -1.20747498544E+01 -1.20743753482E+01 -1.20740060164E+01 -1.20736416430E+01 -1.20732820226E+01 -1.20729269323E+01 -1.20725761292E+01 -1.20722294786E+01 -1.20718868165E+01 -1.20715479513E+01 -1.20712127286E+01 -1.20708809923E+01 -1.20705525961E+01 -1.20702274004E+01 -1.20699052725E+01 -1.20695860858E+01 -1.20692697197E+01 -1.20689560597E+01 -1.20686449957E+01 -1.20683364202E+01 -1.20680302314E+01 -1.20677263315E+01 -1.20674246245E+01 -1.20671261379E+01 -1.20668280270E+01 -1.20665323579E+01 -1.20662377818E+01 -1.20659447925E+01 -1.20656522584E+01 -1.20653631762E+01 -1.20650749886E+01 -1.20647894623E+01 -1.20645053470E+01 -1.20642225733E+01 -1.20639410829E+01 -1.20636608134E+01 -1.20633817049E+01 -1.20631036991E+01 -1.20628267358E+01 -1.20625507578E+01 -1.20622757082E+01 -1.20620015315E+01 -1.20617281728E+01 -1.20614555780E+01 -1.20611836942E+01 -1.20609124686E+01 -1.20606418497E+01 -1.20603717861E+01 -1.20601022273E+01 -1.20598331233E+01 -1.20595644244E+01 -1.20592960816E+01 -1.20590280462E+01 -1.20587602700E+01 -1.20584927049E+01 -1.20582253035E+01 -1.20579580184E+01 -1.20576908027E+01 -1.20574236096E+01 -1.20571563925E+01 -1.20568891052E+01 -1.20566217015E+01 -1.20563541355E+01 -1.20560863613E+01 -1.20558183334E+01 -1.20555500060E+01 -1.20552813338E+01 -1.20550122714E+01 -1.20547427734E+01 -1.20544727946E+01 -1.20542022896E+01 -1.20539312133E+01 -1.20536595205E+01 -1.20533871659E+01 -1.20531141044E+01 -1.20528402898E+01 -1.20525656670E+01 -1.20522901776E+01 -1.20520137799E+01 -1.20517364473E+01 -1.20514494032E+01 -1.20511658042E+01 -1.20508807386E+01 -1.20506076769E+01 -1.20503335103E+01 -1.20500495299E+01 -1.20497643941E+01 -1.20494780358E+01 -1.20491903059E+01 -1.20489011760E+01 -1.20486106092E+01 -1.20483185514E+01 -1.20480249567E+01 -1.20477297775E+01 -1.20474329659E+01 -1.20471344740E+01 -1.20468342533E+01 -1.20465322555E+01 -1.20462284317E+01 -1.20459227329E+01 -1.20456151098E+01 -1.20453055127E+01 -1.20449938919E+01 -1.20446801970E+01 -1.20443643777E+01 -1.20440463830E+01 -1.20437261618E+01 -1.20434036628E+01 -1.20430788339E+01 -1.20427516230E+01 -1.20424219777E+01 -1.20420898449E+01 -1.20417551715E+01 -1.20414179035E+01 -1.20410779871E+01 -1.20407353676E+01 -1.20403899902E+01 -1.20400417995E+01 -1.20396907397E+01 -1.20393367546E+01 -1.20389797874E+01 -1.20386197811E+01 -1.20382566778E+01 -1.20378904197E+01 -1.20375209479E+01 -1.20371482034E+01 -1.20367721265E+01 -1.20363926571E+01 -1.20360097343E+01 -1.20356232971E+01 -1.20352332835E+01 -1.20348396311E+01 -1.20344422770E+01 -1.20340411577E+01 -1.20336362089E+01 -1.20332273659E+01 -1.20328145632E+01 -1.20323977350E+01 -1.20319768144E+01 -1.20315517342E+01 -1.20311224264E+01 -1.20306888222E+01 -1.20302508524E+01 -1.20298084468E+01 -1.20293615347E+01 -1.20289100445E+01 -1.20284539040E+01 -1.20279930403E+01 -1.20275273795E+01 -1.20270568471E+01 -1.20265813677E+01 -1.20261008654E+01 -1.20256152630E+01 -1.20251244829E+01 -1.20246284464E+01 -1.20241270741E+01 -1.20236202856E+01 -1.20231079998E+01 -1.20225901345E+01 -1.20220666068E+01 -1.20215373326E+01 -1.20210022271E+01 -1.20204612046E+01 -1.20199141782E+01 -1.20193610601E+01 -1.20188017617E+01 -1.20182361931E+01 -1.20176642635E+01 -1.20170858811E+01 -1.20165009530E+01 -1.20159093852E+01 -1.20153110828E+01 -1.20147059495E+01 -1.20140938880E+01 -1.20134748000E+01 -1.20128485859E+01 -1.20122151449E+01 -1.20115743752E+01 -1.20109261735E+01 -1.20102704356E+01 -1.20096070558E+01 -1.20089359273E+01 -1.20082569420E+01 -1.20075699904E+01 -1.20068749618E+01 -1.20061717442E+01 -1.20054602240E+01 -1.20047402866E+01 -1.20040118157E+01 -1.20032746937E+01 -1.20025288016E+01 -1.20017740189E+01 -1.20010102237E+01 -1.20002372925E+01 -1.19994551003E+01 -1.19986635208E+01 -1.19978624258E+01 -1.19970516856E+01 -1.19962311691E+01 -1.19954007435E+01 -1.19945602741E+01 -1.19937096248E+01 -1.19928486578E+01 -1.19919772336E+01 -1.19910952106E+01 -1.19902024460E+01 -1.19892987947E+01 -1.19883841102E+01 -1.19874582438E+01 -1.19865210452E+01 -1.19855723621E+01 -1.19846120403E+01 -1.19836399237E+01 -1.19826558541E+01 -1.19816596713E+01 -1.19806512134E+01 -1.19796303160E+01 -1.19785968129E+01 -1.19775505358E+01 -1.19764913140E+01 -1.19754189749E+01 -1.19743333436E+01 -1.19732342430E+01 -1.19721214937E+01 -1.19709949140E+01 -1.19698543200E+01 -1.19686995253E+01 -1.19675303412E+01 -1.19663465766E+01 -1.19651480378E+01 -1.19639345288E+01 -1.19627058510E+01 -1.19614618033E+01 -1.19602021819E+01 -1.19589267806E+01 -1.19576353902E+01 -1.19563277992E+01 -1.19550037930E+01 -1.19536631547E+01 -1.19523056641E+01 -1.19509310984E+01 -1.19495392320E+01 -1.19481298363E+01 -1.19467026797E+01 -1.19452575277E+01 -1.19437941426E+01 -1.19423122839E+01 -1.19408117077E+01 -1.19392921673E+01 -1.19377534123E+01 -1.19361951896E+01 -1.19346172424E+01 -1.19330193109E+01 -1.19314011316E+01 -1.19297624380E+01 -1.19281029597E+01 -1.19264224230E+01 -1.19247205509E+01 -1.19229970623E+01 -1.19212516730E+01 -1.19194840946E+01 -1.19176940354E+01 -1.19158811996E+01 -1.19140452878E+01 -1.19121859965E+01 -1.19103030186E+01 -1.19083960426E+01 -1.19064647533E+01 -1.19045088313E+01 -1.19025279530E+01 -1.19005217907E+01 -1.18984900125E+01 -1.18964322822E+01 -1.18943482591E+01 -1.18922375982E+01 -1.18900999501E+01 -1.18879349609E+01 -1.18857422721E+01 -1.18835215205E+01 -1.18812723382E+01 -1.18789943528E+01 -1.18766871870E+01 -1.18743504584E+01 -1.18719837801E+01 -1.18695867599E+01 -1.18671590009E+01 -1.18647001007E+01 -1.18622096521E+01 -1.18596872425E+01 -1.18571324542E+01 -1.18545448639E+01 -1.18519240433E+01 -1.18492695583E+01 -1.18465809694E+01 -1.18438578315E+01 -1.18410996939E+01 -1.18383061003E+01 -1.18354765883E+01 -1.18326106900E+01 -1.18297079315E+01 -1.18267678328E+01 -1.18237899080E+01 -1.18207736652E+01 -1.18177186060E+01 -1.18146242262E+01 -1.18114900150E+01 -1.18083154554E+01 -1.18051000239E+01 -1.18018431906E+01 -1.17985444188E+01 -1.17952031656E+01 -1.17918188811E+01 -1.17883910086E+01 -1.17849189848E+01 -1.17814022395E+01 -1.17778401954E+01 -1.17742322683E+01 -1.17705778668E+01 -1.17668763926E+01 -1.17631272398E+01 -1.17593297957E+01 -1.17554834399E+01 -1.17515875448E+01 -1.17476414753E+01 -1.17436445886E+01 -1.17395962346E+01 -1.17354957553E+01 -1.17313424853E+01 -1.17271357512E+01 -1.17228748718E+01 -1.17185591581E+01 -1.17141879132E+01 -1.17097604320E+01 -1.17052760016E+01 -1.17007339009E+01 -1.16961334008E+01 -1.16914737637E+01 -1.16867542440E+01 -1.16819740879E+01 -1.16771325329E+01 -1.16722288085E+01 -1.16672621357E+01 -1.16622317268E+01 -1.16571367859E+01 -1.16519765084E+01 -1.16467500813E+01 -1.16414566829E+01 -1.16360954829E+01 -1.16306656423E+01 -1.16251663135E+01 -1.16195966403E+01 -1.16139557577E+01 -1.16082427919E+01 -1.16024568606E+01 -1.15965970726E+01 -1.15906625279E+01 -1.15846523181E+01 -1.15785655257E+01 -1.15724012247E+01 -1.15661584804E+01 -1.15598363491E+01 -1.15534338789E+01 -1.15469501089E+01 -1.15403840697E+01 -1.15337347834E+01 -1.15270012634E+01 -1.15201825147E+01 -1.15132775340E+01 -1.15062853092E+01 -1.14992048204E+01 -1.14920350390E+01 -1.14847749285E+01 -1.14774234441E+01 -1.14699795332E+01 -1.14624421350E+01 -1.14548101812E+01 -1.14470825955E+01 -1.14392582942E+01 -1.14313361861E+01 -1.14233151725E+01 -1.14151941477E+01 -1.14069719987E+01 -1.13986476059E+01 -1.13902198428E+01 -1.13816875762E+01 -1.13730496667E+01 -1.13643049686E+01 -1.13554523303E+01 -1.13464905942E+01 -1.13374185975E+01 -1.13282351716E+01 -1.13189391432E+01 -1.13095293338E+01 -1.13000045605E+01 -1.12903636361E+01 -1.12806053693E+01 -1.12707285649E+01 -1.12607320244E+01 -1.12506145463E+01 -1.12403749260E+01 -1.12300119565E+01 -1.12195244289E+01 -1.12089111322E+01 -1.11981708543E+01 -1.11873023820E+01 -1.11763045015E+01 -1.11651759987E+01 -1.11539156599E+01 -1.11425222721E+01 -1.11309946232E+01 -1.11193315028E+01 -1.11075317027E+01 -1.10955940171E+01 -1.10835172433E+01 -1.10713001820E+01 -1.10589416383E+01 -1.10464404217E+01 -1.10337953469E+01 -1.10210052345E+01 -1.10080689113E+01 -1.09949852110E+01 -1.09817529748E+01 -1.09683710523E+01 -1.09548383014E+01 -1.09411535899E+01 -1.09273157952E+01 -1.09133238056E+01 -1.08991765210E+01 -1.08848728529E+01 -1.08704117258E+01 -1.08557920778E+01 -1.08410128608E+01 -1.08260730418E+01 -1.08109716034E+01 -1.07957075444E+01 -1.07802798809E+01 -1.07646876465E+01 -1.07489298936E+01 -1.07330056938E+01 -1.07169141389E+01 -1.07006543413E+01 -1.06842254353E+01 -1.06676265772E+01 -1.06508569468E+01 -1.06339157474E+01 -1.06168022073E+01 -1.05995155799E+01 -1.05820551448E+01 -1.05644202086E+01 -1.05466101054E+01 -1.05286241977E+01 -1.05104618769E+01 -1.04921225644E+01 -1.04736057118E+01 -1.04549108020E+01 -1.04360373495E+01 -1.04169849013E+01 -1.03977530375E+01 -1.03783413717E+01 -1.03587495516E+01 -1.03389772598E+01 -1.03190242141E+01 -1.02988901679E+01 -1.02785749108E+01 -1.02580782691E+01 -1.02374001059E+01 -1.02165403218E+01 -1.01954988547E+01 -1.01742756806E+01 -1.01528708135E+01 -1.01312843056E+01 -1.01095162472E+01 -1.00875667672E+01 -1.00654360328E+01 -1.00431242496E+01 -1.00206316612E+01 -9.99795854927E+00 -9.97510523320E+00 -9.95207206985E+00 -9.92885945308E+00 -9.90546781333E+00 -9.88189761711E+00 -9.85814936633E+00 -9.83422359768E+00 -9.81012088181E+00 -9.78584182252E+00 -9.76138705583E+00 -9.73675724891E+00 -9.71195309908E+00 -9.68697533254E+00 -9.66182470313E+00 -9.63650199098E+00 -9.61100800106E+00 -9.58534356166E+00 -9.55950952274E+00 -9.53350675426E+00 -9.50733614439E+00 -9.48099859762E+00 -9.45449503284E+00 -9.42782638130E+00 -9.40099358452E+00 -9.37399759212E+00 -9.34683935958E+00 -9.31951984597E+00 -9.29204001160E+00 -9.26440081562E+00 -9.23660321361E+00 -9.20864815513E+00 -9.18053658121E+00 -9.15226942195E+00 -9.12384759396E+00 -9.09527199796E+00 -9.06654351634E+00 -9.03766301083E+00 -9.00863132013E+00 -8.97944925776E+00 -8.95011760994E+00 -8.92063713364E+00 -8.89100855472E+00 -8.86123256637E+00 -8.83130982769E+00 -8.80124096249E+00 -8.77102655844E+00 -8.74066716652E+00 -8.71016330075E+00 -8.67951543842E+00 -8.64872402066E+00 -8.61778945358E+00 -8.58671210983E+00 -8.55549233081E+00 -8.52413042948E+00 -8.49262669383E+00 -8.46098139107E+00 -8.42919477262E+00 -8.39726707992E+00 -8.36519855104E+00 -8.33298942835E+00 -8.30063996705E+00 -8.26815044474E+00 -8.23552117203E+00 -8.20275250426E+00 -8.16984485426E+00 -8.13679870626E+00 -8.10361463086E+00 -8.07029330110E+00 -8.03683550957E+00 -8.00324218655E+00 -7.96951441895E+00 -7.93565347017E+00 -7.90166080053E+00 -7.86753808825E+00 -7.83328725070E+00 -7.79891046566E+00 -7.76441019238E+00 -7.72978919207E+00 -7.69505054737E+00 -7.66019768058E+00 -7.62523436987E+00 -7.59016476332E+00 -7.55499338994E+00 -7.51972516718E+00 -7.48436540428E+00 -7.44891980083E+00 -7.41339443972E+00 -7.37779577384E+00 -7.34213060575E+00 -7.30640605957E+00 -7.27062954426E+00 -7.23480870793E+00 -7.19895138079E+00 -7.16306550763E+00 -7.12715907096E+00 -7.09123999784E+00 -7.05531605303E+00 -7.01939471956E+00 -6.98348306089E+00 -6.94758756521E+00 -6.91171396900E+00 -6.87586705718E+00 -6.84005043633E+00 -6.80426627640E+00 -6.76851501561E+00 -6.73279502210E+00 -6.69710220440E+00 -6.66142956216E+00 -6.62576666758E+00 -6.59009906757E+00 -6.55440759770E+00 -6.51866760099E+00 -6.48284804929E+00 -6.44691057288E+00 -6.41080841629E+00 -6.37448535700E+00 -6.33787464947E+00 -6.30089809230E+00 -6.26346536129E+00 -6.22547380629E+00 -6.18680897241E+00 -6.14734617148E+00 -6.10695348715E+00 -6.06549663077E+00 -6.02284605241E+00 -5.97888662257E+00 -5.93353000286E+00 -5.88672949122E+00 -5.83849664689E+00 -5.78891839454E+00 -5.73817264679E+00 -5.68653989839E+00 -5.63440791479E+00 -5.58226675628E+00 -5.53069209599E+00 -5.48031613627E+00 -5.43178726295E+00 -5.38572159704E+00 -5.34265140462E+00 -5.30297652218E+00 -5.26692526582E+00 -5.23453058870E+00 -5.20562553893E+00 -5.17985949304E+00 -5.15673351552E+00 -5.13565006159E+00 -5.11596981289E+00 -5.09706740061E+00 -5.07837848580E+00 -5.05943294616E+00 -5.03987206431E+00 -5.01945070024E+00 -4.99802768413E+00 -4.97554871896E+00 -4.95202600867E+00 -4.92751799294E+00 -4.90211141643E+00 -4.87590684933E+00 -4.84900791190E+00 -4.82151390107E+00 -4.79351523943E+00 -4.76509108978E+00 -4.73630852340E+00 -4.70722273200E+00 -4.67787789020E+00 -4.64830838238E+00 -4.61854019562E+00 -4.58859234662E+00 -4.55847825834E+00 -4.52820703497E+00 -4.49778460588E+00 -4.46721472461E+00 -4.43649981850E+00 -4.40564169183E+00 -4.37464209003E+00 -4.34350313573E+00 -4.31222764960E+00 -4.28081937014E+00 -4.24928308713E+00 -4.21762470312E+00 -4.18585123681E+00 -4.15397078104E+00 -4.12199242679E+00 -4.08992616317E+00 -4.05778276190E+00 -4.02557365312E+00 -3.99331079817E+00 -3.96100656371E+00 -3.92867360025E+00 -3.89632472740E+00 -3.86397282732E+00 -3.83163074719E+00 -3.79931121105E+00 -3.76702674099E+00 -3.73478958742E+00 -3.70261166801E+00 -3.67050451463E+00 -3.63847922783E+00 -3.60654643819E+00 -3.57471627389E+00 -3.54299833410E+00 -3.51140166767E+00 -3.47993475664E+00 -3.44860550439E+00 -3.41742122813E+00 -3.38638865557E+00 -3.35551392552E+00 -3.32480259301E+00 -3.29425963828E+00 -3.26388948018E+00 -3.23369599408E+00 -3.20368253447E+00 -3.17385196259E+00 -3.14420667941E+00 -3.11474866415E+00 -3.08547951881E+00 -3.05640051893E+00 -3.02751267075E+00 -2.99881677510E+00 -2.97031349808E+00 -2.94200344846E+00 -2.91388726165E+00 -2.88596569002E+00 -2.85823969883E+00 -2.83071056721E+00 -2.80337999292E+00 -2.77625019976E+00 -2.74932404621E+00 -2.72260513188E+00 -2.69609790206E+00 -2.66980774771E+00 -2.64374109394E+00 -2.61790547873E+00 -2.59230961783E+00 -2.56696345182E+00 -2.54187817382E+00 -2.51706623227E+00 -2.49254130889E+00 -2.46831826984E+00 -2.44441308680E+00 -2.42084272827E+00 -2.39762502042E+00 -2.37477847826E+00 -2.35232210832E+00 -2.33027518502E+00 -2.30865700359E+00 -2.28748661317E+00 -2.26678253424E+00 -2.24656246512E+00 -2.22684298257E+00 -2.20763924190E+00 -2.18896468194E+00 -2.17083074029E+00 -2.15324658413E+00 -2.13621886149E+00 -2.11975147768E+00 -2.10384540101E+00 -2.08849850142E+00 -2.07370542536E+00 -2.05945750927E+00 -2.04574273391E+00 -2.03254572091E+00 -2.01984777246E+00 -2.00762695445E+00 -1.99585822293E+00 -1.98451359305E+00 -1.97356234919E+00 -1.96297129425E+00 -1.95270503585E+00 -1.94272630597E+00 -1.93299631072E+00 -1.92347510563E+00 -1.91412199168E+00 -1.90489592666E+00 -1.89575594585E+00 -1.88666158538E+00 -1.87757330320E+00 -1.86845288746E+00 -1.85926384755E+00 -1.84997178507E+00 -1.84054473010E+00 -1.83095344172E+00 -1.82117166979E+00 -1.81117636968E+00 -1.80094786899E+00 -1.79046998392E+00 -1.77973008429E+00 -1.76871910787E+00 -1.75743152541E+00 -1.74586525904E+00 -1.73402155776E+00 -1.72190483429E+00 -1.70952246847E+00 -1.69688458276E+00 -1.68400379546E+00 -1.67089495764E+00 -1.65757487945E+00 -1.64406205135E+00 -1.63037636524E+00 -1.61653884019E+00 -1.60257135673E+00 -1.58849640310E+00 -1.57433683641E+00 -1.56011566060E+00 -1.54585582298E+00 -1.53158003036E+00 -1.51731058510E+00 -1.50306924132E+00 -1.48887708081E+00 -1.47475440814E+00 -1.46072066388E+00 -1.44679435499E+00 -1.43299300109E+00 -1.41933309525E+00 -1.40583007796E+00 -1.39249832291E+00 -1.37935113314E+00 -1.36640074632E+00 -1.35365834781E+00 -1.34113409039E+00 -1.32883711945E+00 -1.31677560284E+00 -1.30495676410E+00 -1.29338691867E+00 -1.28207151199E+00 -1.27101515905E+00 -1.26022168476E+00 -1.24969416470E+00 -1.23943496572E+00 -1.22944578623E+00 -1.21972769576E+00 -1.21028117362E+00 -1.20110614646E+00 -1.19220202462E+00 -1.18356773711E+00 -1.17520176528E+00 -1.16710217498E+00 -1.15926664732E+00 -1.15169250794E+00 -1.14437675494E+00 -1.13731608534E+00 -1.13050692023E+00 -1.12394542864E+00 -1.11762755010E+00 -1.11154901611E+00 -1.10570537045E+00 -1.10009198840E+00 -1.09470409501E+00 -1.08953678244E+00 -1.08458502638E+00 -1.07984370166E+00 -1.07530759714E+00 -1.07097142981E+00 -1.06682985821E+00 -1.06287749532E+00 -1.05910892067E+00 -1.05551869204E+00 -1.05210135653E+00 -1.04885146114E+00 -1.04576356281E+00 -1.04283223806E+00 -1.04005209204E+00 -1.03741776723E+00 -1.03492395160E+00 -1.03256538635E+00 -1.03033687322E+00 -1.02823328126E+00 -1.02624955319E+00 -1.02438071198E+00 -1.02262185765E+00 -1.02096822929E+00 -1.01941484858E+00 -9.99999806181E-01 -1.00000000981E+00 -1.00000000843E+00 -1.00000000735E+00 -1.00000000651E+00 -1.00000000585E+00 -1.00000000533E+00 -1.00000000492E+00 -1.00000000461E+00 -1.00000000436E+00 -1.00000000416E+00 -1.00000000400E+00 -1.00000000387E+00 -1.00000000376E+00 -1.00000000367E+00 -1.00000000360E+00 -1.00000000354E+00 -1.00000000348E+00 -1.00000000343E+00 -1.00000000339E+00 -1.00000000334E+00 -1.00000000331E+00 -1.00000000327E+00 -1.00000000324E+00 -1.00000000321E+00 -1.00000000318E+00 -1.00000000315E+00 -1.00000000312E+00 -1.00000000309E+00 -1.00000000307E+00 -1.00000000305E+00 -1.00000000302E+00 -1.00000000300E+00 -1.00000000298E+00 -1.00000000296E+00 -1.00000000294E+00 -1.00000000292E+00 -1.00000000290E+00 -1.00000000288E+00 -1.00000000287E+00 -1.00000000285E+00 -1.00000000284E+00 -1.00000000282E+00 -1.00000000281E+00 -1.00000000280E+00 -1.00000000279E+00 -1.00000000277E+00 -1.00000000276E+00 -1.00000000275E+00 -1.00000000274E+00 -1.00000000274E+00 -1.00000000273E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -1.00000000262E+00 -2.11696544052E-03 -2.14359358772E-03 -2.17055667579E-03 -2.19785891775E-03 -2.22550457964E-03 -2.25349798115E-03 -2.28184349630E-03 -2.31054555414E-03 -2.33960863943E-03 -2.36903729332E-03 -2.39883611412E-03 -2.42900975793E-03 -2.45956293946E-03 -2.49050043271E-03 -2.52182707171E-03 -2.55354775133E-03 -2.58566742798E-03 -2.61819112042E-03 -2.65112391055E-03 -2.68447094419E-03 -2.71823743187E-03 -2.75242864968E-03 -2.78704994007E-03 -2.82210671269E-03 -2.85760444521E-03 -2.89354868425E-03 -2.92994504616E-03 -2.96679921794E-03 -3.00411695813E-03 -3.04190409771E-03 -3.08016654099E-03 -3.11891026657E-03 -3.15814132822E-03 -3.19786585587E-03 -3.23809005657E-03 -3.27882021543E-03 -3.32006269662E-03 -3.36182394437E-03 -3.40411048394E-03 -3.44692892270E-03 -3.49028595112E-03 -3.53418834382E-03 -3.57864296063E-03 -3.62365674770E-03 -3.66923673850E-03 -3.71539005500E-03 -3.76212390876E-03 -3.80944560204E-03 -3.85736252894E-03 -3.90588217659E-03 -3.95501212627E-03 -4.00476005464E-03 -4.05513373492E-03 -4.10614103810E-03 -4.15778993416E-03 -4.21008849337E-03 -4.26304488746E-03 -4.31666739099E-03 -4.37096438259E-03 -4.42594434626E-03 -4.48161587274E-03 -4.53798766082E-03 -4.59506851871E-03 -4.65286736539E-03 -4.71139323208E-03 -4.77065526353E-03 -4.83066271958E-03 -4.89142497651E-03 -4.95295152854E-03 -5.01525198933E-03 -5.07833609344E-03 -5.14221369790E-03 -5.20689478371E-03 -5.27238945742E-03 -5.33870795272E-03 -5.40586063199E-03 -5.47385798799E-03 -5.54271064543E-03 -5.61242936269E-03 -5.68302503345E-03 -5.75450868844E-03 -5.82689149712E-03 -5.90018476945E-03 -5.97439995765E-03 -6.04954865800E-03 -6.12564261264E-03 -6.20269371140E-03 -6.28071399367E-03 -6.35971565028E-03 -6.43971102540E-03 -6.52071261847E-03 -6.60273308615E-03 -6.68578524431E-03 -6.76988207002E-03 -6.85503670357E-03 -6.94126245056E-03 -7.02857278392E-03 -7.11698134608E-03 -7.20650195106E-03 -7.29714858663E-03 -7.38893541651E-03 -7.48187678259E-03 -7.57598720713E-03 -7.67128139509E-03 -7.76777423637E-03 -7.86548080818E-03 -7.96441637738E-03 -8.06459640283E-03 -8.16603653788E-03 -8.26875263275E-03 -8.37276073704E-03 -8.47807710223E-03 -8.58471818422E-03 -8.69270064589E-03 -8.80204135972E-03 -8.91275741041E-03 -9.02486609759E-03 -9.13838493846E-03 -9.25333167058E-03 -9.36972425459E-03 -9.48758087708E-03 -9.60691995338E-03 -9.72776013047E-03 -9.85012028988E-03 -9.97401955061E-03 -1.00994772722E-02 -1.02265130577E-02 -1.03551467566E-02 -1.04853984683E-02 -1.06172885448E-02 -1.07508375942E-02 -1.08860664839E-02 -1.10229963437E-02 -1.11616485690E-02 -1.13020448246E-02 -1.14442070478E-02 -1.15881574516E-02 -1.17339185285E-02 -1.18815130541E-02 -1.20309640903E-02 -1.21822949891E-02 -1.23355293963E-02 -1.24906912550E-02 -1.26478048097E-02 -1.28068946096E-02 -1.29679855128E-02 -1.31311026902E-02 -1.32962716290E-02 -1.34635181374E-02 -1.36328683478E-02 -1.38043487217E-02 -1.39779860532E-02 -1.41538074733E-02 -1.43318404547E-02 -1.45121128154E-02 -1.46946527233E-02 -1.48794887004E-02 -1.50666496280E-02 -1.52561647502E-02 -1.54480636792E-02 -1.56423763996E-02 -1.58391332731E-02 -1.60383650434E-02 -1.62401028410E-02 -1.64443781876E-02 -1.66512230017E-02 -1.68606696033E-02 -1.70727507189E-02 -1.72874994865E-02 -1.75049494610E-02 -1.77251346196E-02 -1.79480893664E-02 -1.81738485388E-02 -1.84024474119E-02 -1.86339217049E-02 -1.88683075861E-02 -1.91056416787E-02 -1.93459610667E-02 -1.95893033005E-02 -1.98357064028E-02 -2.00852088746E-02 -2.03378497011E-02 -2.05936683580E-02 -2.08527048175E-02 -2.11149995545E-02 -2.13805935532E-02 -2.16495283131E-02 -2.19218458559E-02 -2.21975887317E-02 -2.24768000258E-02 -2.27595233657E-02 -2.30458029275E-02 -2.33356834428E-02 -2.36292102062E-02 -2.39264290816E-02 -2.42273865103E-02 -2.45321295175E-02 -2.48407057199E-02 -2.51531633330E-02 -2.54695511791E-02 -2.57899186943E-02 -2.61143159368E-02 -2.64427935943E-02 -2.67754029921E-02 -2.71121961010E-02 -2.74532255459E-02 -2.77985446131E-02 -2.81482072593E-02 -2.85022681203E-02 -2.88607825187E-02 -2.92238064730E-02 -2.95913967065E-02 -2.99636106559E-02 -3.03405064804E-02 -3.07221430707E-02 -3.11085800585E-02 -3.14998778251E-02 -3.18960975119E-02 -3.22973010289E-02 -3.27035510647E-02 -3.31149110969E-02 -3.35314454013E-02 -3.39532190621E-02 -3.43802979825E-02 -3.48127488947E-02 -3.52506393695E-02 -3.56940378282E-02 -3.61430135532E-02 -3.65976366978E-02 -3.70579782974E-02 -3.75241102811E-02 -3.79961054837E-02 -3.84740376551E-02 -3.89579814731E-02 -3.94480125551E-02 -3.99442074692E-02 -4.04466437467E-02 -4.09553998949E-02 -4.14705554076E-02 -4.19921907788E-02 -4.25203875153E-02 -4.30552281487E-02 -4.35967962491E-02 -4.41451764375E-02 -4.47004543993E-02 -4.52627168982E-02 -4.58320517889E-02 -4.64085480307E-02 -4.69922957026E-02 -4.75833860162E-02 -4.81819113307E-02 -4.87879651667E-02 -4.94016422213E-02 -5.00230383831E-02 -5.06522507462E-02 -5.12893776264E-02 -5.19345185763E-02 -5.25877744004E-02 -5.32492471711E-02 -5.39190402449E-02 -5.45972582783E-02 -5.52840072445E-02 -5.59793944489E-02 -5.66835285472E-02 -5.73965195623E-02 -5.81184789005E-02 -5.88495193688E-02 -5.95897551937E-02 -6.03393020393E-02 -6.10982770232E-02 -6.18667987370E-02 -6.26449872640E-02 -6.34329641974E-02 -6.42308526598E-02 -6.50387773236E-02 -6.58568644288E-02 -6.66852418024E-02 -6.75240388803E-02 -6.83733867265E-02 -6.92334180529E-02 -7.01042672412E-02 -7.09860703639E-02 -7.18789652040E-02 -7.27830912779E-02 -7.36985898576E-02 -7.46256039913E-02 -7.55642785265E-02 -7.65147601330E-02 -7.74771973263E-02 -7.84517404890E-02 -7.94385418943E-02 -8.04377557326E-02 -8.14495381334E-02 -8.24740471893E-02 -8.35114429818E-02 -8.45618876060E-02 -8.56255451960E-02 -8.67025819501E-02 -8.77931661583E-02 -8.88974682265E-02 -9.00156607031E-02 -9.11479183080E-02 -9.22944179589E-02 -9.34553387982E-02 -9.46308622224E-02 -9.58211719097E-02 -9.70264538483E-02 -9.82468963653E-02 -9.94826901574E-02 -1.00734028319E-01 -1.02001106376E-01 -1.03284122310E-01 -1.04583276595E-01 -1.05898772226E-01 -1.07230814752E-01 -1.08579612308E-01 -1.09945375646E-01 -1.11328318167E-01 -1.12728655959E-01 -1.14146607829E-01 -1.15582395334E-01 -1.17036242818E-01 -1.18508377447E-01 -1.19999029245E-01 -1.21508431128E-01 -1.23036818944E-01 -1.24584431505E-01 -1.26151510630E-01 -1.27738301176E-01 -1.29345051083E-01 -1.30972011406E-01 -1.32619436364E-01 -1.34287583367E-01 -1.35976713066E-01 -1.37687089391E-01 -1.39418979592E-01 -1.41172654277E-01 -1.42948387461E-01 -1.44746456606E-01 -1.46567142662E-01 -1.48410730114E-01 -1.50277507027E-01 -1.52167765084E-01 -1.54081799642E-01 -1.56019909772E-01 -1.57982398306E-01 -1.59969571884E-01 -1.61981741005E-01 -1.64019220073E-01 -1.66082327447E-01 -1.68171385487E-01 -1.70286720612E-01 -1.72428663346E-01 -1.74597548368E-01 -1.76793714569E-01 -1.79017505102E-01 -1.81269267434E-01 -1.83549353406E-01 -1.85858119282E-01 -1.88195925807E-01 -1.90563138266E-01 -1.92960126535E-01 -1.95387265145E-01 -1.97844933336E-01 -2.00333515119E-01 -2.02853399335E-01 -2.05404979715E-01 -2.07988654943E-01 -2.10604828716E-01 -2.13253909812E-01 -2.15936312147E-01 -2.18652454844E-01 -2.21402762297E-01 -2.24187664239E-01 -2.27007595808E-01 -2.29862997614E-01 -2.32754315810E-01 -2.35682002158E-01 -2.38646514103E-01 -2.41648314843E-01 -2.44687873401E-01 -2.47765664704E-01 -2.50882169647E-01 -2.54037875172E-01 -2.57233274347E-01 -2.60468866441E-01 -2.63745157005E-01 -2.67062657945E-01 -2.70421887604E-01 -2.73823370846E-01 -2.77267639133E-01 -2.80755230614E-01 -2.84286690203E-01 -2.87862569668E-01 -2.91483427716E-01 -2.95149830078E-01 -2.98862349602E-01 -3.02621566338E-01 -3.06428067628E-01 -3.10282448204E-01 -3.14185310274E-01 -3.18137263618E-01 -3.22138925685E-01 -3.26190921685E-01 -3.30293884692E-01 -3.34448455739E-01 -3.38655283917E-01 -3.42915026480E-01 -3.47228348946E-01 -3.51595925197E-01 -3.56018437592E-01 -3.60496577062E-01 -3.65031043227E-01 -3.69622544504E-01 -3.74271798211E-01 -3.78979530684E-01 -3.83746477391E-01 -3.88573383042E-01 -3.93461001710E-01 -3.98410096943E-01 -4.03421441881E-01 -4.08495819385E-01 -4.13634022157E-01 -4.18836852855E-01 -4.24105124223E-01 -4.29439659218E-01 -4.34841291137E-01 -4.40310863744E-01 -4.45849231404E-01 -4.51457259217E-01 -4.57135823144E-01 -4.62885810148E-01 -4.68708118338E-01 -4.74603657097E-01 -4.80573347222E-01 -4.86618121081E-01 -4.92738922740E-01 -4.98936708117E-01 -5.05212445133E-01 -5.11567113858E-01 -5.18001706654E-01 -5.24517228337E-01 -5.31114696332E-01 -5.37795140827E-01 -5.44559604933E-01 -5.51409144839E-01 -5.58344829976E-01 -5.65367743189E-01 -5.72478980896E-01 -5.79679653249E-01 -5.86970884314E-01 -5.94353812239E-01 -6.01829589431E-01 -6.09399382724E-01 -6.17064373565E-01 -6.24825758185E-01 -6.32684747784E-01 -6.40642568714E-01 -6.48700462670E-01 -6.56859686871E-01 -6.65121514243E-01 -6.73487233622E-01 -6.81958149945E-01 -6.90535584444E-01 -6.99220874839E-01 -7.08015375536E-01 -7.16920457843E-01 -7.25937510159E-01 -7.35067938183E-01 -7.44313165124E-01 -7.53674631901E-01 -7.63153797365E-01 -7.72752138505E-01 -7.82471150666E-01 -7.92312347770E-01 -8.02277262527E-01 -8.12367446648E-01 -8.22584471082E-01 -8.32929926239E-01 -8.43405422201E-01 -8.54012588962E-01 -8.64753076654E-01 -8.75628555776E-01 -8.86640717419E-01 -8.97791273506E-01 -9.09081957023E-01 -9.20514522253E-01 -9.32090745019E-01 -9.43812422909E-01 -9.55681375519E-01 -9.67699444703E-01 -9.79868494790E-01 -9.92190412834E-01 -1.00466710886E+00 -1.01730051610E+00 -1.03009259123E+00 -1.04304531460E+00 -1.05616069048E+00 -1.06944074731E+00 -1.08288753794E+00 -1.09650313983E+00 -1.11028965530E+00 -1.12424921180E+00 -1.13838396209E+00 -1.15269608448E+00 -1.16718778308E+00 -1.18186128800E+00 -1.19671885554E+00 -1.21176276848E+00 -1.22699533621E+00 -1.24241889497E+00 -1.25803580807E+00 -1.27384846602E+00 -1.28985928677E+00 -1.30607071588E+00 -1.32248522664E+00 -1.33910532030E+00 -1.35593352618E+00 -1.37297240179E+00 -1.39022453302E+00 -1.40769253419E+00 -1.42537904818E+00 -1.44328674654E+00 -1.46141832951E+00 -1.47977652609E+00 -1.49836409411E+00 -1.51718382019E+00 -1.53623851980E+00 -1.55553103713E+00 -1.57506424515E+00 -1.59484104544E+00 -1.61486436814E+00 -1.63513717175E+00 -1.65566244303E+00 -1.67644319672E+00 -1.69748247535E+00 -1.71878334892E+00 -1.74034891458E+00 -1.76218229627E+00 -1.78428664430E+00 -1.80666513483E+00 -1.82932096942E+00 -1.85225737436E+00 -1.87547760007E+00 -1.89898492037E+00 -1.92278263169E+00 -1.94687405219E+00 -1.97126252084E+00 -1.99595139637E+00 -2.02094405617E+00 -2.04624389503E+00 -2.07185432385E+00 -2.09777876820E+00 -2.12402066677E+00 -2.15058346969E+00 -2.17747063676E+00 -2.20468563547E+00 -2.23223193892E+00 -2.26011302359E+00 -2.28833236693E+00 -2.31689344477E+00 -2.34579972853E+00 -2.37505468230E+00 -2.40466175960E+00 -2.43462440007E+00 -2.46494602576E+00 -2.49563003730E+00 -2.52667980976E+00 -2.55809868826E+00 -2.58988998321E+00 -2.62205696539E+00 -2.65460286056E+00 -2.68753084378E+00 -2.72084403345E+00 -2.75454548483E+00 -2.78863818324E+00 -2.82312503686E+00 -2.85800886901E+00 -2.89329241003E+00 -2.92897828864E+00 -2.96506902276E+00 -3.00156700983E+00 -3.03847451653E+00 -3.07579366790E+00 -3.11352643585E+00 -3.15167462694E+00 -3.19023986962E+00 -3.22922360051E+00 -3.26862705015E+00 -3.30845122782E+00 -3.34869690552E+00 -3.38936460117E+00 -3.43045456079E+00 -3.47196673984E+00 -3.51390078346E+00 -3.55625600576E+00 -3.59903136797E+00 -3.64222545556E+00 -3.68583645409E+00 -3.72986212391E+00 -3.77429977366E+00 -3.81914623235E+00 -3.86439782023E+00 -3.91005031817E+00 -3.95609893569E+00 -4.00253827748E+00 -4.04936230844E+00 -4.09656431712E+00 -4.14413687762E+00 -4.19207180983E+00 -4.24036013804E+00 -4.28899204787E+00 -4.33795684143E+00 -4.38724289082E+00 -4.43683758986E+00 -4.48672730403E+00 -4.53689731873E+00 -4.58733178568E+00 -4.63801366772E+00 -4.68892468177E+00 -4.74004524021E+00 -4.79135439061E+00 -4.84282975391E+00 -4.89444746105E+00 -4.94618208838E+00 -4.99800659160E+00 -5.04989223874E+00 -5.10180854206E+00 -5.15372318919E+00 -5.20560197372E+00 -5.25740872536E+00 -5.30910524013E+00 -5.36065121067E+00 -5.41200415718E+00 -5.46311935927E+00 -5.51394978915E+00 -5.56444604669E+00 -5.61455629674E+00 -5.66422620933E+00 -5.71339890342E+00 -5.76201489474E+00 -5.81001204851E+00 -5.85732553785E+00 -5.90388780862E+00 -5.94962855172E+00 -5.99447468372E+00 -6.03835033695E+00 -6.08117686011E+00 -6.12287283053E+00 -6.16335407950E+00 -6.20253373181E+00 -6.24032226098E+00 -6.27662756165E+00 -6.31135504061E+00 -6.34440772810E+00 -6.37568641095E+00 -6.40508978932E+00 -6.43251465871E+00 -6.45785611905E+00 -6.48100781259E+00 -6.50186219242E+00 -6.52031082336E+00 -6.53624471700E+00 -6.54955470257E+00 -6.56013183533E+00 -6.56786784389E+00 -6.57265561807E+00 -6.57438973843E+00 -6.57296704865E+00 -6.56828727154E+00 -6.56025366941E+00 -6.54877374901E+00 -6.53376001117E+00 -6.51513074446E+00 -6.49281086241E+00 -6.46673278251E+00 -6.43683734558E+00 -6.40307477262E+00 -6.36540565638E+00 -6.32380198360E+00 -6.27824818346E+00 -6.22874219682E+00 -6.17529655998E+00 -6.11793949579E+00 -6.05671600390E+00 -5.99168894089E+00 -5.92294008004E+00 -5.85057113915E+00 -5.77470476372E+00 -5.69548545149E+00 -5.61308040299E+00 -5.52768028124E+00 -5.43949986240E+00 -5.34877855732E+00 -5.25578078256E+00 -5.16079615713E+00 -5.06413949987E+00 -4.96615059959E+00 -4.86719372832E+00 -4.76765686529E+00 -4.66795059659E+00 -4.56850665273E+00 -4.46977604332E+00 -4.37222674474E+00 -4.27634089409E+00 -4.18261143903E+00 -4.09153819123E+00 -4.00362322853E+00 -3.91936559036E+00 -3.83925521143E+00 -3.76376604168E+00 -3.69334830651E+00 -3.62841987213E+00 -3.56935669661E+00 -3.51648237156E+00 -3.47005679220E+00 -3.43026403935E+00 -3.39719961688E+00 -3.37085726663E+00 -3.35111568287E+00 -3.33772557456E+00 -3.33029767977E+00 -3.32829252817E+00 -3.33101297900E+00 -3.33760083892E+00 -3.34703919272E+00 -3.35816246568E+00 -3.36967668691E+00 -3.38019294618E+00 -3.38827764343E+00 -3.39252383366E+00 -3.39164878853E+00 -3.38462385612E+00 -3.37084383442E+00 -3.35034442739E+00 -3.32407797716E+00 -3.29425961880E+00 -3.26388946037E+00 -3.23369597390E+00 -3.20368251387E+00 -3.17385194153E+00 -3.14420665785E+00 -3.11474864205E+00 -3.08547949616E+00 -3.05640049569E+00 -3.02751264691E+00 -2.99881675067E+00 -2.97031347306E+00 -2.94200342286E+00 -2.91388723551E+00 -2.88596566338E+00 -2.85823967175E+00 -2.83071053974E+00 -2.80337996514E+00 -2.77625017176E+00 -2.74932401809E+00 -2.72260510372E+00 -2.69609787396E+00 -2.66980771976E+00 -2.64374106622E+00 -2.61790545131E+00 -2.59230959075E+00 -2.56696342511E+00 -2.54187814748E+00 -2.51706620626E+00 -2.49254128313E+00 -2.46831824422E+00 -2.44441306118E+00 -2.42084270245E+00 -2.39762499419E+00 -2.37477845140E+00 -2.35232208057E+00 -2.33027515614E+00 -2.30865697336E+00 -2.28748658139E+00 -2.26678250077E+00 -2.24656242987E+00 -2.22684294552E+00 -2.20763920314E+00 -2.18896464162E+00 -2.17083069866E+00 -2.15324654153E+00 -2.13621881835E+00 -2.11975143449E+00 -2.10384535830E+00 -2.08849845977E+00 -2.07370538532E+00 -2.05945747137E+00 -2.04574269865E+00 -2.03254568870E+00 -2.01984774361E+00 -2.00762692916E+00 -1.99585820127E+00 -1.98451357497E+00 -1.97356233449E+00 -1.96297128263E+00 -1.95270502687E+00 -1.94272629912E+00 -1.93299630542E+00 -1.92347510122E+00 -1.91412198751E+00 -1.90489592208E+00 -1.89575594022E+00 -1.88666157811E+00 -1.87757329377E+00 -1.86845287543E+00 -1.85926383257E+00 -1.84997176688E+00 -1.84054470852E+00 -1.83095341670E+00 -1.82117164132E+00 -1.81117633784E+00 -1.80094783394E+00 -1.79046994585E+00 -1.77973004345E+00 -1.76871906453E+00 -1.75743147986E+00 -1.74586521158E+00 -1.73402150868E+00 -1.72190478387E+00 -1.70952241699E+00 -1.69688453048E+00 -1.68400374260E+00 -1.67089490440E+00 -1.65757482602E+00 -1.64406199789E+00 -1.63037631188E+00 -1.61653878703E+00 -1.60257130385E+00 -1.58849635058E+00 -1.57433678429E+00 -1.56011560890E+00 -1.54585577173E+00 -1.53157997956E+00 -1.51731053475E+00 -1.50306919140E+00 -1.48887703131E+00 -1.47475435904E+00 -1.46072061515E+00 -1.44679430660E+00 -1.43299295302E+00 -1.41933304745E+00 -1.40583003042E+00 -1.39249827560E+00 -1.37935108603E+00 -1.36640069940E+00 -1.35365830105E+00 -1.34113404376E+00 -1.32883707296E+00 -1.31677555647E+00 -1.30495671784E+00 -1.29338687252E+00 -1.28207146595E+00 -1.27101511312E+00 -1.26022163896E+00 -1.24969411903E+00 -1.23943492019E+00 -1.22944574085E+00 -1.21972765056E+00 -1.21028112862E+00 -1.20110610169E+00 -1.19220198009E+00 -1.18356769286E+00 -1.17520172134E+00 -1.16710213138E+00 -1.15926660408E+00 -1.15169246509E+00 -1.14437671253E+00 -1.13731604339E+00 -1.13050687879E+00 -1.12394538772E+00 -1.11762750974E+00 -1.11154897635E+00 -1.10570533132E+00 -1.10009194992E+00 -1.09470405722E+00 -1.08953674537E+00 -1.08458499004E+00 -1.07984366610E+00 -1.07530756237E+00 -1.07097139585E+00 -1.06682982509E+00 -1.06287746304E+00 -1.05910888926E+00 -1.05551866151E+00 -1.05210132689E+00 -1.04885143240E+00 -1.04576353499E+00 -1.04283221115E+00 -1.04005206605E+00 -1.03741774215E+00 -1.03492392743E+00 -1.03256536309E+00 -1.03033685087E+00 -1.02823325980E+00 -1.02624953262E+00 -1.02438069228E+00 -1.02262183881E+00 -1.02096821128E+00 -1.01941483140E+00 -9.99999806205E-01 -1.00000000984E+00 -1.00000000846E+00 -1.00000000737E+00 -1.00000000653E+00 -1.00000000587E+00 -1.00000000535E+00 -1.00000000495E+00 -1.00000000463E+00 -1.00000000438E+00 -1.00000000418E+00 -1.00000000402E+00 -1.00000000389E+00 -1.00000000378E+00 -1.00000000370E+00 -1.00000000362E+00 -1.00000000356E+00 -1.00000000350E+00 -1.00000000345E+00 -1.00000000341E+00 -1.00000000337E+00 -1.00000000333E+00 -1.00000000329E+00 -1.00000000326E+00 -1.00000000323E+00 -1.00000000320E+00 -1.00000000317E+00 -1.00000000314E+00 -1.00000000312E+00 -1.00000000309E+00 -1.00000000307E+00 -1.00000000305E+00 -1.00000000302E+00 -1.00000000300E+00 -1.00000000298E+00 -1.00000000296E+00 -1.00000000294E+00 -1.00000000292E+00 -1.00000000291E+00 -1.00000000289E+00 -1.00000000288E+00 -1.00000000286E+00 -1.00000000285E+00 -1.00000000283E+00 -1.00000000282E+00 -1.00000000281E+00 -1.00000000280E+00 -1.00000000279E+00 -1.00000000278E+00 -1.00000000277E+00 -1.00000000276E+00 -1.00000000275E+00 -1.00000000264E+00 -1.00000000264E+00 -1.00000000264E+00 -1.00000000264E+00 -1.00000000264E+00 -1.00000000264E+00 -1.00000000264E+00 -1.00000000264E+00 -1.00000000264E+00 -1.00000000264E+00 -1.00000000264E+00 -1.00000000264E+00 -1.00000000264E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 -1.00000000265E+00 4 2S 0 1.17609989798E-03 1.19087913804E-03 1.20584409866E-03 1.22099711367E-03 1.23634037086E-03 1.25187588736E-03 1.26760616658E-03 1.28353362846E-03 1.29966074201E-03 1.31599000698E-03 1.33252395428E-03 1.34926514639E-03 1.36621617725E-03 1.38337967327E-03 1.40075829480E-03 1.41835473488E-03 1.43617171912E-03 1.45421200762E-03 1.47247839476E-03 1.49097370954E-03 1.50970081625E-03 1.52866261486E-03 1.54786204143E-03 1.56730206848E-03 1.58698570557E-03 1.60691599969E-03 1.62709603561E-03 1.64752893649E-03 1.66821786443E-03 1.68916602079E-03 1.71037664663E-03 1.73185302332E-03 1.75359847308E-03 1.77561635934E-03 1.79791008737E-03 1.82048310469E-03 1.84333890168E-03 1.86648101203E-03 1.88991301333E-03 1.91363852757E-03 1.93766122168E-03 1.96198480811E-03 1.98661304542E-03 2.01154973878E-03 2.03679874052E-03 2.06236395083E-03 2.08824931823E-03 2.11445884022E-03 2.14099656386E-03 2.16786658632E-03 2.19507305558E-03 2.22262017105E-03 2.25051218410E-03 2.27875339876E-03 2.30734817243E-03 2.33630091642E-03 2.36561609666E-03 2.39529823437E-03 2.42535190671E-03 2.45578174747E-03 2.48659244778E-03 2.51778875678E-03 2.54937548235E-03 2.58135749178E-03 2.61373971256E-03 2.64652713305E-03 2.67972480326E-03 2.71333783558E-03 2.74737140554E-03 2.78183075256E-03 2.81672118076E-03 2.85204805972E-03 2.88781682528E-03 2.92403298033E-03 2.96070209563E-03 2.99782981066E-03 3.03542183438E-03 3.07348394614E-03 3.11202199650E-03 3.15104190808E-03 3.19054967646E-03 3.23055137102E-03 3.27105313586E-03 3.31206119067E-03 3.35358183169E-03 3.39562143258E-03 3.43818644538E-03 3.48128340143E-03 3.52491891236E-03 3.56909967100E-03 3.61383245239E-03 3.65912411477E-03 3.70498160056E-03 3.75141193735E-03 3.79842223898E-03 3.84601970650E-03 3.89421162925E-03 3.94300538591E-03 3.99240844558E-03 4.04242836881E-03 4.09307280874E-03 4.14434951219E-03 4.19626632076E-03 4.24883117195E-03 4.30205210034E-03 4.35593723870E-03 4.41049481917E-03 4.46573317444E-03 4.52166073896E-03 4.57828605008E-03 4.63561774936E-03 4.69366458371E-03 4.75243540669E-03 4.81193917977E-03 4.87218497354E-03 4.93318196908E-03 4.99493945920E-03 5.05746684978E-03 5.12077366106E-03 5.18486952906E-03 5.24976420683E-03 5.31546756593E-03 5.38198959772E-03 5.44934041483E-03 5.51753025253E-03 5.58656947021E-03 5.65646855274E-03 5.72723811205E-03 5.79888888849E-03 5.87143175239E-03 5.94487770557E-03 6.01923788284E-03 6.09452355355E-03 6.17074612314E-03 6.24791713462E-03 6.32604827030E-03 6.40515135334E-03 6.48523834945E-03 6.56632136839E-03 6.64841266568E-03 6.73152464428E-03 6.81566985627E-03 6.90086100457E-03 6.98711094463E-03 7.07443268621E-03 7.16283939510E-03 7.25234439491E-03 7.34296116888E-03 7.43470336164E-03 7.52758478110E-03 7.62161940026E-03 7.71682135906E-03 7.81320496629E-03 7.91078470149E-03 8.00957521684E-03 8.10959133913E-03 8.21084807169E-03 8.31336059639E-03 8.41714427559E-03 8.52221465420E-03 8.62858746168E-03 8.73627861409E-03 8.84530421619E-03 8.95568056348E-03 9.06742414433E-03 9.18055164211E-03 9.29507993734E-03 9.41102610981E-03 9.52840744084E-03 9.64724141541E-03 9.76754572443E-03 9.88933826695E-03 1.00126371524E-02 1.01374607031E-02 1.02638274561E-02 1.03917561659E-02 1.05212658066E-02 1.06523755746E-02 1.07851048902E-02 1.09194734009E-02 1.10555009833E-02 1.11932077456E-02 1.13326140302E-02 1.14737404161E-02 1.16166077212E-02 1.17612370054E-02 1.19076495723E-02 1.20558669724E-02 1.22059110057E-02 1.23578037236E-02 1.25115674325E-02 1.26672246955E-02 1.28247983358E-02 1.29843114387E-02 1.31457873550E-02 1.33092497032E-02 1.34747223723E-02 1.36422295247E-02 1.38117955989E-02 1.39834453123E-02 1.41572036638E-02 1.43330959371E-02 1.45111477029E-02 1.46913848223E-02 1.48738334495E-02 1.50585200345E-02 1.52454713261E-02 1.54347143751E-02 1.56262765369E-02 1.58201854744E-02 1.60164691615E-02 1.62151558855E-02 1.64162742502E-02 1.66198531793E-02 1.68259219190E-02 1.70345100413E-02 1.72456474468E-02 1.74593643682E-02 1.76756913729E-02 1.78946593663E-02 1.81162995950E-02 1.83406436500E-02 1.85677234692E-02 1.87975713413E-02 1.90302199087E-02 1.92657021705E-02 1.95040514855E-02 1.97453015761E-02 1.99894865306E-02 2.02366408070E-02 2.04867992358E-02 2.07399970235E-02 2.09962697557E-02 2.12556534000E-02 2.15181843098E-02 2.17838992269E-02 2.20528352850E-02 2.23250300131E-02 2.26005213380E-02 2.28793475885E-02 2.31615474977E-02 2.34471602066E-02 2.37362252673E-02 2.40287826462E-02 2.43248727268E-02 2.46245363134E-02 2.49278146338E-02 2.52347493427E-02 2.55453825248E-02 2.58597566977E-02 2.61779148152E-02 2.64999002704E-02 2.68257568985E-02 2.71555289802E-02 2.74892612442E-02 2.78269988709E-02 2.81687874945E-02 2.85146732067E-02 2.88647025592E-02 2.92189225667E-02 2.95773807095E-02 2.99401249367E-02 3.03072036686E-02 3.06786657996E-02 3.10545607010E-02 3.14349382232E-02 3.18198486989E-02 3.22093429451E-02 3.26034722657E-02 3.30022884543E-02 3.34058437962E-02 3.38141910707E-02 3.42273835536E-02 3.46454750192E-02 3.50685197424E-02 3.54965725011E-02 3.59296885774E-02 3.63679237605E-02 3.68113343477E-02 3.72599771464E-02 3.77139094759E-02 3.81731891687E-02 3.86378745721E-02 3.91080245496E-02 3.95836984818E-02 4.00649562680E-02 4.05518583270E-02 4.10444655980E-02 4.15428395415E-02 4.20470421398E-02 4.25571358976E-02 4.30731838428E-02 4.35952495259E-02 4.41233970211E-02 4.46576909256E-02 4.51981963598E-02 4.57449789665E-02 4.62981049111E-02 4.68576408804E-02 4.74236540818E-02 4.79962122426E-02 4.85753836083E-02 4.91612369418E-02 4.97538415212E-02 5.03532671383E-02 5.09595840965E-02 5.15728632089E-02 5.21931757950E-02 5.28205936789E-02 5.34551891859E-02 5.40970351393E-02 5.47462048570E-02 5.54027721480E-02 5.60668113080E-02 5.67383971157E-02 5.74176048277E-02 5.81045101740E-02 5.87991893526E-02 5.95017190244E-02 6.02121763069E-02 6.09306387688E-02 6.16571844228E-02 6.23918917191E-02 6.31348395384E-02 6.38861071842E-02 6.46457743747E-02 6.54139212348E-02 6.61906282871E-02 6.69759764431E-02 6.77700469933E-02 6.85729215974E-02 6.93846822737E-02 7.02054113885E-02 7.10351916443E-02 7.18741060683E-02 7.27222379998E-02 7.35796710776E-02 7.44464892261E-02 7.53227766421E-02 7.62086177796E-02 7.71040973352E-02 7.80093002323E-02 7.89243116050E-02 7.98492167809E-02 8.07841012643E-02 8.17290507174E-02 8.26841509420E-02 8.36494878600E-02 8.46251474933E-02 8.56112159425E-02 8.66077793664E-02 8.76149239586E-02 8.86327359252E-02 8.96613014609E-02 9.07007067240E-02 9.17510378114E-02 9.28123807324E-02 9.38848213813E-02 9.49684455096E-02 9.60633386974E-02 9.71695863232E-02 9.82872735336E-02 9.94164852117E-02 1.00557305944E-01 1.01709819988E-01 1.02874111236E-01 1.04050263181E-01 1.05238358879E-01 1.06438480912E-01 1.07650711348E-01 1.08875131703E-01 1.10111822898E-01 1.11360865218E-01 1.12622338267E-01 1.13896320926E-01 1.15182891304E-01 1.16482126692E-01 1.17794103517E-01 1.19118897287E-01 1.20456582546E-01 1.21807232815E-01 1.23170920544E-01 1.24547717054E-01 1.25937692478E-01 1.27340915708E-01 1.28757454331E-01 1.30187374570E-01 1.31630741220E-01 1.33087617584E-01 1.34558065408E-01 1.36042144810E-01 1.37539914216E-01 1.39051430284E-01 1.40576747836E-01 1.42115919779E-01 1.43668997032E-01 1.45236028446E-01 1.46817060725E-01 1.48412138346E-01 1.50021303471E-01 1.51644595868E-01 1.53282052816E-01 1.54933709022E-01 1.56599596525E-01 1.58279744606E-01 1.59974179692E-01 1.61682925254E-01 1.63406001714E-01 1.65143426338E-01 1.66895213137E-01 1.68661372753E-01 1.70441912359E-01 1.72236835544E-01 1.74046142200E-01 1.75869828410E-01 1.77707886325E-01 1.79560304049E-01 1.81427065517E-01 1.83308150364E-01 1.85203533808E-01 1.87113186511E-01 1.89037074455E-01 1.90975158800E-01 1.92927395755E-01 1.94893736433E-01 1.96874126712E-01 1.98868507091E-01 2.00876812539E-01 2.02898972352E-01 2.04934909996E-01 2.06984542955E-01 2.09047782572E-01 2.11124533892E-01 2.13214695497E-01 2.15318159341E-01 2.17434810587E-01 2.19564527432E-01 2.21707180934E-01 2.23862634841E-01 2.26030745412E-01 2.28211361233E-01 2.30404323037E-01 2.32609463520E-01 2.34826607150E-01 2.37055569976E-01 2.39296159439E-01 2.41548174173E-01 2.43811403809E-01 2.46085628772E-01 2.48370620082E-01 2.50666139147E-01 2.52971937556E-01 2.55287756869E-01 2.57613328406E-01 2.59948373033E-01 2.62292600946E-01 2.64645711454E-01 2.67007392756E-01 2.69377321724E-01 2.71755163676E-01 2.74140572149E-01 2.76533188679E-01 2.78932642564E-01 2.81338550639E-01 2.83750517046E-01 2.86168132994E-01 2.88590976535E-01 2.91018612321E-01 2.93450591371E-01 2.95886450838E-01 2.98325713766E-01 3.00767888855E-01 3.03212470222E-01 3.05658937165E-01 3.08106753921E-01 3.10555369430E-01 3.13004217097E-01 3.15452714553E-01 3.17900263418E-01 3.20346249066E-01 3.22790040389E-01 3.25230989565E-01 3.27668431821E-01 3.30101685208E-01 3.32530050368E-01 3.34952810309E-01 3.37369230180E-01 3.39778557050E-01 3.42180019690E-01 3.44572828355E-01 3.46956174575E-01 3.49329230946E-01 3.51691150925E-01 3.54041068630E-01 3.56378098646E-01 3.58701335837E-01 3.61009855158E-01 3.63302711478E-01 3.65578939407E-01 3.67837553131E-01 3.70077546252E-01 3.72297891634E-01 3.74497541262E-01 3.76675426105E-01 3.78830455983E-01 3.80961519458E-01 3.83067483714E-01 3.85147194463E-01 3.87199475854E-01 3.89223130396E-01 3.91216938885E-01 3.93179660353E-01 3.95110032023E-01 3.97006769274E-01 3.98868565628E-01 4.00694092745E-01 4.02482000427E-01 4.04230916649E-01 4.05939447597E-01 4.07606177723E-01 4.09229669817E-01 4.10808465097E-01 4.12341083315E-01 4.13826022884E-01 4.15261761018E-01 4.16646753899E-01 4.17979436857E-01 4.19258224577E-01 4.20481511321E-01 4.21647671176E-01 4.22755058323E-01 4.23802007331E-01 4.24786833470E-01 4.25707833054E-01 4.26563283808E-01 4.27351445254E-01 4.28070559136E-01 4.28718849859E-01 4.29294524964E-01 4.29795775628E-01 4.30220777195E-01 4.30567689733E-01 4.30834658627E-01 4.31019815197E-01 4.31121277351E-01 4.31137150271E-01 4.31065527126E-01 4.30904489829E-01 4.30652109817E-01 4.30306448872E-01 4.29865559978E-01 4.29327488208E-01 4.28690271654E-01 4.27951942392E-01 4.27110527480E-01 4.26164050003E-01 4.25110530148E-01 4.23947986323E-01 4.22674436314E-01 4.21287898482E-01 4.19786393001E-01 4.18167943137E-01 4.16430576566E-01 4.14572326737E-01 4.12591234270E-01 4.10485348408E-01 4.08252728498E-01 4.05891445523E-01 4.03399583670E-01 4.00775241951E-01 3.98016535850E-01 3.95121599032E-01 3.92088585078E-01 3.88915669270E-01 3.85601050416E-01 3.82142952721E-01 3.78539627689E-01 3.74789356080E-01 3.70890449891E-01 3.66841254395E-01 3.62640150199E-01 3.58285555360E-01 3.53775927521E-01 3.49109766097E-01 3.44285614486E-01 3.39302062320E-01 3.34157747749E-01 3.28851359750E-01 3.23381640474E-01 3.17747387614E-01 3.11947456808E-01 3.05980764053E-01 2.99846288159E-01 2.93543073207E-01 2.87070231037E-01 2.80426943743E-01 2.73612466192E-01 2.66626128543E-01 2.59467338781E-01 2.52135585255E-01 2.44630439218E-01 2.36951557368E-01 2.29098684386E-01 2.21071655470E-01 2.12870398851E-01 2.04494938310E-01 1.95945395674E-01 1.87221993287E-01 1.78325056473E-01 1.69255015965E-01 1.60012410309E-01 1.50597888243E-01 1.41012211036E-01 1.31256254794E-01 1.21331012732E-01 1.11237597398E-01 1.00977242863E-01 9.05513068542E-02 7.99612728515E-02 6.92087521268E-02 5.82954857342E-02 4.72233464450E-02 3.59943406255E-02 2.46106100565E-02 1.30744336895E-02 1.38822933916E-03 -1.04454446939E-02 -2.24238880721E-02 -3.45442569478E-02 -4.68035625730E-02 -5.91986699991E-02 -7.17262968748E-02 -8.43830123524E-02 -9.71652361150E-02 -1.10069237538E-01 -1.23091135003E-01 -1.36226895390E-01 -1.49472333768E-01 -1.62823113319E-01 -1.76274745536E-01 -1.89822590740E-01 -2.03461858975E-01 -2.17187611337E-01 -2.30994761839E-01 -2.44878079879E-01 -2.58832193433E-01 -2.72851593077E-01 -2.86930636979E-01 -3.01063556970E-01 -3.15244465827E-01 -3.29467365853E-01 -3.43726158814E-01 -3.58014657201E-01 -3.72326596686E-01 -3.86655649499E-01 -4.00995438244E-01 -4.15339549480E-01 -4.29681546132E-01 -4.44014977591E-01 -4.58333386204E-01 -4.72630308770E-01 -4.86899271807E-01 -5.01133779635E-01 -5.15327294882E-01 -5.29473211720E-01 -5.43564823062E-01 -5.57595283786E-01 -5.71557572880E-01 -5.85444457894E-01 -5.99248465239E-01 -6.12961859572E-01 -6.26576634707E-01 -6.40084517371E-01 -6.53476983699E-01 -6.66745287000E-01 -6.79880494155E-01 -6.92873527311E-01 -7.05715207355E-01 -7.18396296019E-01 -7.30907534181E-01 -7.43239674884E-01 -7.55383510457E-01 -7.67329893935E-01 -7.79069755456E-01 -7.90594114610E-01 -8.01894089802E-01 -8.12960905626E-01 -8.23785899106E-01 -8.34360525479E-01 -8.44676364038E-01 -8.54725124370E-01 -8.64498653223E-01 -8.73988942113E-01 -8.83188135711E-01 -8.92088541010E-01 -9.00682637206E-01 -9.08963086217E-01 -9.16922743757E-01 -9.24554670832E-01 -9.31852145571E-01 -9.38808675266E-01 -9.45418008509E-01 -9.51674147338E-01 -9.57571359264E-01 -9.63104189121E-01 -9.68267470640E-01 -9.73056337676E-01 -9.77466235032E-01 -9.81492928830E-01 -9.85132516370E-01 -9.88381435455E-01 -9.91236473149E-01 -9.93694773936E-01 -9.95753847272E-01 -9.97411574508E-01 -9.98666215183E-01 -9.99516412664E-01 -9.99961199147E-01 -1.00000000000E+00 -9.99632637459E-01 -9.98859333665E-01 -9.97680713058E-01 -9.96097804116E-01 -9.94112040445E-01 -9.91725261236E-01 -9.88939711076E-01 -9.85758039124E-01 -9.82183297661E-01 -9.78218940018E-01 -9.73868817883E-01 -9.69137177996E-01 -9.64028658249E-01 -9.58548283178E-01 -9.52701458872E-01 -9.46493967302E-01 -9.39931960070E-01 -9.33021951605E-01 -9.25770811788E-01 -9.18185758040E-01 -9.10274346863E-01 -9.02044464854E-01 -8.93504319186E-01 -8.84662427582E-01 -8.75527607772E-01 -8.66108966443E-01 -8.56415887702E-01 -8.46458021032E-01 -8.36245268768E-01 -8.25787773090E-01 -8.15095902530E-01 -8.04180238005E-01 -7.93051558383E-01 -7.81720825568E-01 -7.70199169132E-01 -7.58497870484E-01 -7.46628346585E-01 -7.34602133225E-01 -7.22430867865E-01 -7.10126272065E-01 -6.97700133515E-01 -6.85164287689E-01 -6.72530599156E-01 -6.59810942580E-01 -6.47017183448E-01 -6.34161158573E-01 -6.21254656437E-01 -6.08309397414E-01 -5.95337013966E-01 -5.82349030867E-01 -5.69356845557E-01 -5.56371708689E-01 -5.43404704984E-01 -5.30466734473E-01 -5.17568494232E-01 -5.04720460702E-01 -4.91932872692E-01 -4.79215715161E-01 -4.66578703863E-01 -4.54031270940E-01 -4.41582551537E-01 -4.29241371508E-01 -4.17016236260E-01 -4.04915320789E-01 -3.92946460931E-01 -3.81117145856E-01 -3.69434511802E-01 -3.57905337051E-01 -3.46536038129E-01 -3.35332667187E-01 -3.24300910542E-01 -3.13446088313E-01 -3.02773155099E-01 -2.92286701620E-01 -2.81990957273E-01 -2.71889793494E-01 -2.61986727873E-01 -2.52284928916E-01 -2.42787221387E-01 -2.33496092152E-01 -2.24413696420E-01 -2.15541864349E-01 -2.06882107907E-01 -1.98435627951E-01 -1.90203321467E-01 -1.82185788910E-01 -1.74383341623E-01 -1.66796009294E-01 -1.59423547434E-01 -1.52265444871E-01 -1.45320931239E-01 -1.38588984486E-01 -1.32068338401E-01 -1.25757490180E-01 -1.19654708048E-01 -1.13758038968E-01 -1.08065316463E-01 -1.02574168573E-01 -9.72820259818E-02 -9.21861303320E-02 -8.72835427569E-02 -8.25711526410E-02 -7.80456866279E-02 -7.37037178803E-02 -6.95416755955E-02 -6.55558547715E-02 -6.17424262133E-02 -5.80974467625E-02 -5.46168697280E-02 -5.12965554887E-02 -4.81322822357E-02 -4.51197568168E-02 -4.22546256414E-02 -3.95324856027E-02 -3.69488949713E-02 -3.44993842120E-02 -3.21794666776E-02 -2.99846491310E-02 -2.79104420498E-02 -2.59523696673E-02 -2.41059797084E-02 -2.23668527785E-02 -2.07306113683E-02 -1.91929284415E-02 -1.77495355724E-02 -1.63962306096E-02 -1.51288848396E-02 -1.39434496352E-02 -1.28359625699E-02 -1.18025529911E-02 -1.08394470422E-02 -9.94297213327E-03 -9.10956085801E-03 -8.33575436377E-03 -7.61820518009E-03 -6.95367951727E-03 -6.33905904764E-03 -5.77134218580E-03 -5.24764488579E-03 -4.76520097542E-03 -4.32136204996E-03 -3.91359694859E-03 -3.53949083857E-03 -3.19674393291E-03 -2.88316986824E-03 -2.59669376990E-03 -2.33535003184E-03 -2.09727983873E-03 -1.88072845773E-03 -1.68404232681E-03 -1.50566596639E-03 -1.34413873990E-03 -1.19809148841E-03 -1.06624306322E-03 -9.47396779412E-04 -8.40436811852E-04 -7.44324554113E-04 -6.58094958977E-04 -5.80852877899E-04 -5.11769415029E-04 -4.50078309718E-04 -3.95072359568E-04 -3.46099894220E-04 -3.02561307984E-04 -2.63905657312E-04 -2.29627326764E-04 -1.99262764631E-04 -1.72387286633E-04 -1.48611943029E-04 -1.27580441068E-04 -1.08966110681E-04 -9.24688967803E-05 -7.78123559797E-05 -6.47406290895E-05 -5.30153527426E-05 -4.24124638126E-05 -3.27188382429E-05 -2.37286909164E-05 -1.52396443945E-05 -7.04835064237E-06 1.05448016412E-06 9.28987106163E-06 1.78974690413E-05 2.71435499334E-05 3.73305382654E-05 4.88090890096E-05 6.19927253223E-05 7.73761044987E-05 9.55578414796E-05 1.17269207116E-04 1.43410383121E-04 1.75096455835E-04 2.13715983820E-04 2.61005832600E-04 3.19147100711E-04 3.90888454900E-04 4.79705170391E-04 5.90004798712E-04 7.27393882213E-04 8.99024802178E-04 1.11404809526E-03 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1.50 1.50 -1.39958997292E-04 -1.41719873551E-04 -1.43502898908E-04 -1.45308351964E-04 -1.47136514824E-04 -1.48987673142E-04 -1.50862116167E-04 -1.52760136783E-04 -1.54682031560E-04 -1.56628100798E-04 -1.58598648575E-04 -1.60593982792E-04 -1.62614415226E-04 -1.64660261571E-04 -1.66731841497E-04 -1.68829478691E-04 -1.70953500914E-04 -1.73104240049E-04 -1.75282032153E-04 -1.77487217511E-04 -1.79720140687E-04 -1.81981150581E-04 -1.84270600479E-04 -1.86588848113E-04 -1.88936255714E-04 -1.91313190070E-04 -1.93720022580E-04 -1.96157129319E-04 -1.98624891088E-04 -2.01123693480E-04 -2.03653926940E-04 -2.06215986820E-04 -2.08810273448E-04 -2.11437192186E-04 -2.14097153497E-04 -2.16790573005E-04 -2.19517871562E-04 -2.22279475313E-04 -2.25075815766E-04 -2.27907329855E-04 -2.30774460009E-04 -2.33677654223E-04 -2.36617366128E-04 -2.39594055060E-04 -2.42608186132E-04 -2.45660230309E-04 -2.48750664479E-04 -2.51879971529E-04 -2.55048640420E-04 -2.58257166263E-04 -2.61506050396E-04 -2.64795800465E-04 -2.68126930500E-04 -2.71499960996E-04 -2.74915418998E-04 -2.78373838178E-04 -2.81875758920E-04 -2.85421728408E-04 -2.89012300707E-04 -2.92648036850E-04 -2.96329504930E-04 -3.00057280184E-04 -3.03831945084E-04 -3.07654089430E-04 -3.11524310439E-04 -3.15443212843E-04 -3.19411408978E-04 -3.23429518884E-04 -3.27498170397E-04 -3.31617999254E-04 -3.35789649187E-04 -3.40013772025E-04 -3.44291027796E-04 -3.48622084831E-04 -3.53007619866E-04 -3.57448318151E-04 -3.61944873554E-04 -3.66497988672E-04 -3.71108374940E-04 -3.75776752738E-04 -3.80503851513E-04 -3.85290409883E-04 -3.90137175758E-04 -3.95044906456E-04 -4.00014368820E-04 -4.05046339341E-04 -4.10141604273E-04 -4.15300959764E-04 -4.20525211975E-04 -4.25815177205E-04 -4.31171682023E-04 -4.36595563396E-04 -4.42087668817E-04 -4.47648856438E-04 -4.53279995209E-04 -4.58981965007E-04 -4.64755656777E-04 -4.70601972672E-04 -4.76521826191E-04 -4.82516142325E-04 -4.88585857699E-04 -4.94731920720E-04 -5.00955291724E-04 -5.07256943127E-04 -5.13637859575E-04 -5.20099038103E-04 -5.26641488282E-04 -5.33266232387E-04 -5.39974305549E-04 -5.46766755919E-04 -5.53644644833E-04 -5.60609046978E-04 -5.67661050557E-04 -5.74801757462E-04 -5.82032283446E-04 -5.89353758294E-04 -5.96767326005E-04 -6.04274144965E-04 -6.11875388134E-04 -6.19572243222E-04 -6.27365912882E-04 -6.35257614894E-04 -6.43248582354E-04 -6.51340063871E-04 -6.59533323758E-04 -6.67829642231E-04 -6.76230315611E-04 -6.84736656523E-04 -6.93349994104E-04 -7.02071674209E-04 -7.10903059622E-04 -7.19845530268E-04 -7.28900483432E-04 -7.38069333972E-04 -7.47353514544E-04 -7.56754475825E-04 -7.66273686738E-04 -7.75912634686E-04 -7.85672825777E-04 -7.95555785068E-04 -8.05563056796E-04 -8.15696204623E-04 -8.25956811881E-04 -8.36346481816E-04 -8.46866837841E-04 -8.57519523791E-04 -8.68306204176E-04 -8.79228564443E-04 -8.90288311242E-04 -9.01487172689E-04 -9.12826898634E-04 -9.24309260944E-04 -9.35936053768E-04 -9.47709093825E-04 -9.59630220687E-04 -9.71701297062E-04 -9.83924209093E-04 -9.96300866643E-04 -1.00883320360E-03 -1.02152317818E-03 -1.03437277323E-03 -1.04738399654E-03 -1.06055888114E-03 -1.07389948566E-03 -1.08740789461E-03 -1.10108621870E-03 -1.11493659524E-03 -1.12896118837E-03 -1.14316218949E-03 -1.15754181755E-03 -1.17210231941E-03 -1.18684597020E-03 -1.20177507366E-03 -1.21689196251E-03 -1.23219899882E-03 -1.24769857437E-03 -1.26339311100E-03 -1.27928506106E-03 -1.29537690770E-03 -1.31167116535E-03 -1.32817038003E-03 -1.34487712981E-03 -1.36179402518E-03 -1.37892370946E-03 -1.39626885922E-03 -1.41383218473E-03 -1.43161643030E-03 -1.44962437480E-03 -1.46785883204E-03 -1.48632265123E-03 -1.50501871740E-03 -1.52394995190E-03 -1.54311931280E-03 -1.56252979541E-03 -1.58218443268E-03 -1.60208629574E-03 -1.62223849434E-03 -1.64264417735E-03 -1.66330653325E-03 -1.68422879061E-03 -1.70541421865E-03 -1.72686612767E-03 -1.74858786965E-03 -1.77058283870E-03 -1.79285447164E-03 -1.81540624853E-03 -1.83824169319E-03 -1.86136437377E-03 -1.88477790331E-03 -1.90848594030E-03 -1.93249218924E-03 -1.95680040122E-03 -1.98141437456E-03 -2.00633795530E-03 -2.03157503790E-03 -2.05712956579E-03 -2.08300553203E-03 -2.10920697987E-03 -2.13573800345E-03 -2.16260274841E-03 -2.18980541252E-03 -2.21735024637E-03 -2.24524155402E-03 -2.27348369367E-03 -2.30208107832E-03 -2.33103817652E-03 -2.36035951301E-03 -2.39004966945E-03 -2.42011328514E-03 -2.45055505773E-03 -2.48137974398E-03 -2.51259216046E-03 -2.54419718436E-03 -2.57619975421E-03 -2.60860487065E-03 -2.64141759725E-03 -2.67464306127E-03 -2.70828645445E-03 -2.74235303387E-03 -2.77684812271E-03 -2.81177711115E-03 -2.84714545715E-03 -2.88295868734E-03 -2.91922239787E-03 -2.95594225529E-03 -2.99312399743E-03 -3.03077343431E-03 -3.06889644903E-03 -3.10749899871E-03 -3.14658711541E-03 -3.18616690705E-03 -3.22624455842E-03 -3.26682633209E-03 -3.30791856944E-03 -3.34952769160E-03 -3.39166020049E-03 -3.43432267982E-03 -3.47752179615E-03 -3.52126429987E-03 -3.56555702632E-03 -3.61040689682E-03 -3.65582091978E-03 -3.70180619174E-03 -3.74836989857E-03 -3.79551931650E-03 -3.84326181334E-03 -3.89160484955E-03 -3.94055597948E-03 -3.99012285251E-03 -4.04031321426E-03 -4.09113490780E-03 -4.14259587486E-03 -4.19470415710E-03 -4.24746789735E-03 -4.30089534089E-03 -4.35499483674E-03 -4.40977483894E-03 -4.46524390792E-03 -4.52141071182E-03 -4.57828402780E-03 -4.63587274350E-03 -4.69418585835E-03 -4.75323248503E-03 -4.81302185085E-03 -4.87356329926E-03 -4.93486629122E-03 -4.99694040678E-03 -5.05979534650E-03 -5.12344093301E-03 -5.18788711252E-03 -5.25314395640E-03 -5.31922166275E-03 -5.38613055800E-03 -5.45388109848E-03 -5.52248387214E-03 -5.59194960013E-03 -5.66228913852E-03 -5.73351347999E-03 -5.80563375554E-03 -5.87866123624E-03 -5.95260733501E-03 -6.02748360838E-03 -6.10330175829E-03 -6.18007363398E-03 -6.25781123378E-03 -6.33652670701E-03 -6.41623235592E-03 -6.49694063754E-03 -6.57866416570E-03 -6.66141571298E-03 -6.74520821270E-03 -6.83005476096E-03 -6.91596861867E-03 -7.00296321365E-03 -7.09105214275E-03 -7.18024917391E-03 -7.27056824840E-03 -7.36202348295E-03 -7.45462917198E-03 -7.54839978983E-03 -7.64334999304E-03 -7.73949462265E-03 -7.83684870650E-03 -7.93542746163E-03 -8.03524629661E-03 -8.13632081399E-03 -8.23866681276E-03 -8.34230029078E-03 -8.44723744732E-03 -8.55349468561E-03 -8.66108861538E-03 -8.77003605548E-03 -8.88035403654E-03 -8.99205980361E-03 -9.10517081885E-03 -9.21970476435E-03 -9.33567954480E-03 -9.45311329037E-03 -9.57202435955E-03 -9.69243134199E-03 -9.81435306146E-03 -9.93780857879E-03 -1.00628171949E-02 -1.01893984536E-02 -1.03175721452E-02 -1.04473583091E-02 -1.05787772369E-02 -1.07118494760E-02 -1.08465958328E-02 -1.09830373755E-02 -1.11211954378E-02 -1.12610916222E-02 -1.14027478034E-02 -1.15461861315E-02 -1.16914290360E-02 -1.18384992287E-02 -1.19874197077E-02 -1.21382137610E-02 -1.22909049700E-02 -1.24455172132E-02 -1.26020746701E-02 -1.27606018249E-02 -1.29211234706E-02 -1.30836647124E-02 -1.32482509723E-02 -1.34149079925E-02 -1.35836618398E-02 -1.37545389098E-02 -1.39275659306E-02 -1.41027699676E-02 -1.42801784273E-02 -1.44598190620E-02 -1.46417199739E-02 -1.48259096195E-02 -1.50124168144E-02 -1.52012707376E-02 -1.53925009364E-02 -1.55861373304E-02 -1.57822102172E-02 -1.59807502764E-02 -1.61817885748E-02 -1.63853565713E-02 -1.65914861216E-02 -1.68002094839E-02 -1.70115593233E-02 -1.72255687173E-02 -1.74422711611E-02 -1.76617005727E-02 -1.78838912985E-02 -1.81088781188E-02 -1.83366962527E-02 -1.85673813648E-02 -1.88009695697E-02 -1.90374974387E-02 -1.92770020048E-02 -1.95195207694E-02 -1.97650917076E-02 -2.00137532745E-02 -2.02655444115E-02 -2.05205045522E-02 -2.07786736289E-02 -2.10400920788E-02 -2.13048008508E-02 -2.15728414115E-02 -2.18442557524E-02 -2.21190863961E-02 -2.23973764036E-02 -2.26791693807E-02 -2.29645094853E-02 -2.32534414346E-02 -2.35460105118E-02 -2.38422625739E-02 -2.41422440586E-02 -2.44460019920E-02 -2.47535839964E-02 -2.50650382974E-02 -2.53804137321E-02 -2.56997597568E-02 -2.60231264552E-02 -2.63505645461E-02 -2.66821253919E-02 -2.70178610068E-02 -2.73578240652E-02 -2.77020679104E-02 -2.80506465629E-02 -2.84036147296E-02 -2.87610278123E-02 -2.91229419170E-02 -2.94894138628E-02 -2.98605011914E-02 -3.02362621762E-02 -3.06167558320E-02 -3.10020419248E-02 -3.13921809810E-02 -3.17872342982E-02 -3.21872639542E-02 -3.25923328183E-02 -3.30025045607E-02 -3.34178436634E-02 -3.38384154311E-02 -3.42642860012E-02 -3.46955223555E-02 -3.51321923310E-02 -3.55743646310E-02 -3.60221088366E-02 -3.64754954183E-02 -3.69345957479E-02 -3.73994821098E-02 -3.78702277139E-02 -3.83469067072E-02 -3.88295941864E-02 -3.93183662107E-02 -3.98132998142E-02 -4.03144730193E-02 -4.08219648495E-02 -4.13358553429E-02 -4.18562255659E-02 -4.23831576267E-02 -4.29167346891E-02 -4.34570409874E-02 -4.40041618400E-02 -4.45581836642E-02 -4.51191939913E-02 -4.56872814813E-02 -4.62625359383E-02 -4.68450483260E-02 -4.74349107834E-02 -4.80322166407E-02 -4.86370604359E-02 -4.92495379305E-02 -4.98697461271E-02 -5.04977832858E-02 -5.11337489418E-02 -5.17777439226E-02 -5.24298703660E-02 -5.30902317382E-02 -5.37589328523E-02 -5.44360798866E-02 -5.51217804037E-02 -5.58161433703E-02 -5.65192791758E-02 -5.72312996532E-02 -5.79523180987E-02 -5.86824492926E-02 -5.94218095200E-02 -6.01705165922E-02 -6.09286898684E-02 -6.16964502774E-02 -6.24739203403E-02 -6.32612241931E-02 -6.40584876096E-02 -6.48658380253E-02 -6.56834045612E-02 -6.65113180480E-02 -6.73497110513E-02 -6.81987178962E-02 -6.90584746935E-02 -6.99291193654E-02 -7.08107916727E-02 -7.17036332410E-02 -7.26077875891E-02 -7.35234001566E-02 -7.44506183323E-02 -7.53895914840E-02 -7.63404709875E-02 -7.73034102569E-02 -7.82785647758E-02 -7.92660921280E-02 -8.02661520301E-02 -8.12789063633E-02 -8.23045192076E-02 -8.33431568744E-02 -8.43949879421E-02 -8.54601832906E-02 -8.65389161374E-02 -8.76313620741E-02 -8.87376991036E-02 -8.98581076785E-02 -9.09927707394E-02 -9.21418737550E-02 -9.33056047623E-02 -9.44841544079E-02 -9.56777159900E-02 -9.68864855014E-02 -9.81106616738E-02 -9.93504460220E-02 -1.00606042890E-01 -1.01877659498E-01 -1.03165505990E-01 -1.04469795482E-01 -1.05790744112E-01 -1.07128571093E-01 -1.08483498761E-01 -1.09855752633E-01 -1.11245561458E-01 -1.12653157272E-01 -1.14078775460E-01 -1.15522654809E-01 -1.16985037567E-01 -1.18466169509E-01 -1.19966299997E-01 -1.21485682039E-01 -1.23024572363E-01 -1.24583231475E-01 -1.26161923734E-01 -1.27760917417E-01 -1.29380484794E-01 -1.31020902199E-01 -1.32682450105E-01 -1.34365413205E-01 -1.36070080482E-01 -1.37796745298E-01 -1.39545705472E-01 -1.41317263366E-01 -1.43111725971E-01 -1.44929404994E-01 -1.46770616953E-01 -1.48635683263E-01 -1.50524930340E-01 -1.52438689691E-01 -1.54377298018E-01 -1.56341097320E-01 -1.58330434995E-01 -1.60345663953E-01 -1.62387142721E-01 -1.64455235557E-01 -1.66550312566E-01 -1.68672749821E-01 -1.70822929480E-01 -1.73001239912E-01 -1.75208075823E-01 -1.77443838389E-01 -1.79708935386E-01 -1.82003781330E-01 -1.84328797611E-01 -1.86684412641E-01 -1.89071062000E-01 -1.91489188580E-01 -1.93939242744E-01 -1.96421682480E-01 -1.98936973557E-01 -2.01485589694E-01 -2.04068012723E-01 -2.06684732757E-01 -2.09336248367E-01 -2.12023066755E-01 -2.14745703936E-01 -2.17504684922E-01 -2.20300543902E-01 -2.23133824440E-01 -2.26005079659E-01 -2.28914872444E-01 -2.31863775631E-01 -2.34852372213E-01 -2.37881255542E-01 -2.40951029531E-01 -2.44062308861E-01 -2.47215719187E-01 -2.50411897350E-01 -2.53651491580E-01 -2.56935161713E-01 -2.60263579388E-01 -2.63637428264E-01 -2.67057404222E-01 -2.70524215564E-01 -2.74038583218E-01 -2.77601240929E-01 -2.81212935448E-01 -2.84874426718E-01 -2.88586488045E-01 -2.92349906264E-01 -2.96165481897E-01 -3.00034029289E-01 -3.03956376741E-01 -3.07933366616E-01 -3.11965855435E-01 -3.16054713945E-01 -3.20200827166E-01 -3.24405094412E-01 -3.28668429277E-01 -3.32991759596E-01 -3.37376027357E-01 -3.41822188583E-01 -3.46331213157E-01 -3.50904084602E-01 -3.55541799807E-01 -3.60245368681E-01 -3.65015813746E-01 -3.69854169653E-01 -3.74761482615E-01 -3.79738809746E-01 -3.84787218305E-01 -3.89907784829E-01 -3.95101594148E-01 -4.00369738271E-01 -4.05713315126E-01 -4.11133427158E-01 -4.16631179749E-01 -4.22207679463E-01 -4.27864032091E-01 -4.33601340495E-01 -4.39420702203E-01 -4.45323206778E-01 -4.51309932902E-01 -4.57381945184E-01 -4.63540290648E-01 -4.69785994901E-01 -4.76120057927E-01 -4.82543449512E-01 -4.89057104250E-01 -4.95661916119E-01 -5.02358732575E-01 -5.09148348167E-01 -5.16031497605E-01 -5.23008848277E-01 -5.30080992166E-01 -5.37248437140E-01 -5.44511597572E-01 -5.51870784274E-01 -5.59326193688E-01 -5.66877896314E-01 -5.74525824342E-01 -5.82269758451E-01 -5.90109313750E-01 -5.98043924831E-01 -6.06072829915E-01 -6.14195054074E-01 -6.22409391501E-01 -6.30714386846E-01 -6.39108315595E-01 -6.47589163518E-01 -6.56154605195E-01 -6.64801981664E-01 -6.73528277226E-01 -6.82330095477E-01 -6.91203634647E-01 -7.00144662338E-01 -7.09148489798E-01 -7.18209945860E-01 -7.27323350742E-01 -7.36482489888E-01 -7.45680588109E-01 -7.54910284275E-01 -7.64163606875E-01 -7.73431950792E-01 -7.82706055669E-01 -7.91975986296E-01 -8.01231115487E-01 -8.10460109957E-01 -8.19650919739E-01 -8.28790771744E-01 -8.37866168069E-01 -8.46862889718E-01 -8.55766006403E-01 -8.64559893114E-01 -8.73228254172E-01 -8.81754155411E-01 -8.90120065201E-01 -8.98307904896E-01 -9.06299109282E-01 -9.14074697511E-01 -9.21615354875E-01 -9.28901525663E-01 -9.35913517167E-01 -9.42631614705E-01 -9.49036207309E-01 -9.55107923470E-01 -9.60827776021E-01 -9.66177314953E-01 -9.71138786582E-01 -9.75695297154E-01 -9.79830978562E-01 -9.83531153501E-01 -9.86782496971E-01 -9.89573190697E-01 -9.91893066703E-01 -9.93733735956E-01 -9.95088697811E-01 -9.95953425818E-01 -9.96325425417E-01 -9.96204259156E-01 -9.95591535294E-01 -9.94490856110E-01 -9.92907722890E-01 -9.90849395498E-01 -9.88324705683E-01 -9.85343824888E-01 -9.81917989397E-01 -9.78059188268E-01 -9.73779822724E-01 -9.69092349745E-01 -9.64008927518E-01 -9.58541086555E-01 -9.52699457674E-01 -9.46493597133E-01 -9.39931960070E-01 -9.33022086498E-01 -9.25771062740E-01 -9.18186119475E-01 -9.10274812992E-01 -9.02045029701E-01 -8.93504976614E-01 -8.84663171314E-01 -8.75528431419E-01 -8.66109863527E-01 -8.56416851677E-01 -8.46459045310E-01 -8.36246346741E-01 -8.25788898151E-01 -8.15097068096E-01 -8.04181437537E-01 -7.93052785404E-01 -7.81722073687E-01 -7.70200432060E-01 -7.58499142051E-01 -7.46629620760E-01 -7.34603404132E-01 -7.22432129796E-01 -7.10127519499E-01 -6.97701361128E-01 -6.85165490369E-01 -6.72531772014E-01 -6.59812080964E-01 -6.47018282949E-01 -6.34162215039E-01 -6.21255665976E-01 -6.08310356406E-01 -5.95337919066E-01 -5.82349879012E-01 -5.69357633969E-01 -5.56372434880E-01 -5.43405366754E-01 -5.30467329916E-01 -5.17569021733E-01 -5.04720918934E-01 -4.91933260618E-01 -4.79216032028E-01 -4.66578949197E-01 -4.54031444543E-01 -4.41582653480E-01 -4.29241402120E-01 -4.17016196125E-01 -4.04915210733E-01 -3.92946282016E-01 -3.81116899364E-01 -3.69434199229E-01 -3.57904960093E-01 -3.46535598667E-01 -3.35332167279E-01 -3.24300352407E-01 -3.13445474319E-01 -3.02772487747E-01 -2.92285983535E-01 -2.81990191185E-01 -2.71888982231E-01 -2.61985874341E-01 -2.52284036091E-01 -2.42786292300E-01 -2.33495129877E-01 -2.24412704065E-01 -2.15540845039E-01 -2.06881064777E-01 -1.98434564137E-01 -1.90202240092E-01 -1.82184693080E-01 -1.74382234414E-01 -1.66794893747E-01 -1.59422426549E-01 -1.52264321597E-01 -1.45319808472E-01 -1.38587865062E-01 -1.32067225096E-01 -1.25756385701E-01 -1.19653615035E-01 -1.13756959991E-01 -1.08064254021E-01 -1.02573125094E-01 -9.72810038255E-02 -9.21851317890E-02 -8.72825700523E-02 -8.25702079378E-02 -7.80447720311E-02 -7.37028354421E-02 -6.95408273214E-02 -6.55550426273E-02 -6.17416521334E-02 -5.80967126590E-02 -5.46161775011E-02 -5.12959070383E-02 -4.81316794744E-02 -4.51192016845E-02 -4.22541201212E-02 -3.95320317389E-02 -3.69484948892E-02 -3.44990401397E-02 -3.21791809707E-02 -2.99844242994E-02 -2.79102807877E-02 -2.59522748867E-02 -2.41059545762E-02 -2.23669007578E-02 -2.07307362646E-02 -1.91931344542E-02 -1.77498273524E-02 -1.63966133239E-02 -1.51293642442E-02 -1.39440321559E-02 -1.28366553949E-02 -1.18033641744E-02 -1.08403856208E-02 -9.94404825969E-03 -9.11078595123E-03 -8.33714128003E-03 -7.61976840772E-03 -6.95543539867E-03 -6.34102603290E-03 -5.77354112280E-03 -5.25009935256E-03 -4.76793766164E-03 -4.32441119544E-03 -3.91699284806E-03 -3.54327242374E-03 -3.20095544462E-03 -2.88786163379E-03 -2.60192310350E-03 -2.34118227916E-03 -2.10378959045E-03 -1.88800096155E-03 -1.69217513304E-03 -1.51477084844E-03 -1.35434393919E-03 -1.20954434245E-03 -1.07911308721E-03 -9.61879285046E-04 -8.56757163927E-04 -7.62743185182E-04 -6.78913286655E-04 -6.04420298641E-04 -5.38491583851E-04 -4.80426958599E-04 -4.29596960117E-04 -3.85441534604E-04 -3.47469232992E-04 -3.15257017008E-04 -2.88450797776E-04 -2.66766853937E-04 -2.49994307353E-04 -2.37998873488E-04 -2.30728152576E-04 -2.28218789259E-04 -2.30605905759E-04 -2.38135311004E-04 -2.51179110769E-04 -2.70255498571E-04 -2.96053702431E-04 -3.29465309906E-04 -3.71623507177E-04 -4.23952166078E-04 -4.88227219479E-04 -5.66653411344E-04 -6.61962146189E-04 -7.77546652230E-04 -9.17582429147E-04 -1.08722999333E-03 -1.29287526173E-03 -1.54243054055E-03 -1.84571478057E-03 -2.21493499435E-03 -2.66529709359E-03 -3.21578270474E-03 -3.89013937326E-03 -4.71814579201E-03 -5.73723238247E-03 -6.99456218350E-03 -8.54970952902E-03 -1.04781170679E-02 -1.28755688666E-02 -1.58639934644E-02 -1.95990123702E-02 -2.42797855015E-02 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 3S 0 1.34398588910E-03 1.36087483716E-03 1.37797601704E-03 1.39529209571E-03 1.41282557324E-03 1.43057875472E-03 1.44855450089E-03 1.46675557713E-03 1.48518480492E-03 1.50384504083E-03 1.52273917704E-03 1.54187014184E-03 1.56124089944E-03 1.58085445115E-03 1.60071383709E-03 1.62082213474E-03 1.64118245876E-03 1.66179796326E-03 1.68267184150E-03 1.70380732634E-03 1.72520769091E-03 1.74687624917E-03 1.76881635626E-03 1.79103140906E-03 1.81352484671E-03 1.83630015117E-03 1.85936084753E-03 1.88271050479E-03 1.90635273644E-03 1.93029120081E-03 1.95452960161E-03 1.97907168863E-03 2.00392125832E-03 2.02908215424E-03 2.05455826774E-03 2.08035353849E-03 2.10647195508E-03 2.13291755565E-03 2.15969442847E-03 2.18680671256E-03 2.21425859829E-03 2.24205432807E-03 2.27019819697E-03 2.29869455334E-03 2.32754779943E-03 2.35676239214E-03 2.38634284368E-03 2.41629372215E-03 2.44661965231E-03 2.47732531621E-03 2.50841545393E-03 2.53989486435E-03 2.57176840568E-03 2.60404099637E-03 2.63671761581E-03 2.66980330502E-03 2.70330316742E-03 2.73722236962E-03 2.77156614216E-03 2.80633978030E-03 2.84154864480E-03 2.87719816274E-03 2.91329382828E-03 2.94984120354E-03 2.98684591936E-03 3.02431367621E-03 3.06225024494E-03 3.10066146772E-03 3.13955325888E-03 3.17893160576E-03 3.21880256961E-03 3.25917228651E-03 3.30004696824E-03 3.34143290321E-03 3.38333645740E-03 3.42576407528E-03 3.46872228077E-03 3.51221767819E-03 3.55625695325E-03 3.60084687402E-03 3.64599429189E-03 3.69170614265E-03 3.73798944743E-03 3.78485131378E-03 3.83229893669E-03 3.88033959965E-03 3.92898067568E-03 3.97822962847E-03 4.02809401340E-03 4.07858147871E-03 4.12969976654E-03 4.18145671411E-03 4.23386025485E-03 4.28691841951E-03 4.34063933738E-03 4.39503123745E-03 4.45010244959E-03 4.50586140574E-03 4.56231664118E-03 4.61947679570E-03 4.67735061490E-03 4.73594695141E-03 4.79527476618E-03 4.85534312977E-03 4.91616122365E-03 4.97773834149E-03 5.04008389055E-03 5.10320739296E-03 5.16711848714E-03 5.23182692913E-03 5.29734259399E-03 5.36367547723E-03 5.43083569621E-03 5.49883349159E-03 5.56767922876E-03 5.63738339932E-03 5.70795662260E-03 5.77940964710E-03 5.85175335205E-03 5.92499874891E-03 5.99915698296E-03 6.07423933484E-03 6.15025722214E-03 6.22722220099E-03 6.30514596768E-03 6.38404036034E-03 6.46391736050E-03 6.54478909485E-03 6.62666783687E-03 6.70956600856E-03 6.79349618216E-03 6.87847108190E-03 6.96450358576E-03 7.05160672720E-03 7.13979369695E-03 7.22907784484E-03 7.31947268173E-03 7.41099188132E-03 7.50364928195E-03 7.59745888852E-03 7.69243487440E-03 7.78859158340E-03 7.88594353165E-03 7.98450540963E-03 8.08429208410E-03 8.18531860016E-03 8.28760018326E-03 8.39115224123E-03 8.49599036636E-03 8.60213033749E-03 8.70958812213E-03 8.81837987856E-03 8.92852195801E-03 9.04003090682E-03 9.15292346862E-03 9.26721658656E-03 9.38292740553E-03 9.50007327444E-03 9.61867174846E-03 9.73874059136E-03 9.86029777778E-03 9.98336149562E-03 1.01079501484E-02 1.02340823576E-02 1.03617769650E-02 1.04910530355E-02 1.06219298589E-02 1.07544269530E-02 1.08885640657E-02 1.10243611778E-02 1.11618385053E-02 1.13010165022E-02 1.14419158626E-02 1.15845575240E-02 1.17289626695E-02 1.18751527304E-02 1.20231493892E-02 1.21729745820E-02 1.23246505012E-02 1.24781995987E-02 1.26336445879E-02 1.27910084473E-02 1.29503144226E-02 1.31115860302E-02 1.32748470594E-02 1.34401215758E-02 1.36074339237E-02 1.37768087297E-02 1.39482709050E-02 1.41218456486E-02 1.42975584505E-02 1.44754350941E-02 1.46555016602E-02 1.48377845291E-02 1.50223103842E-02 1.52091062149E-02 1.53981993198E-02 1.55896173099E-02 1.57833881117E-02 1.59795399701E-02 1.61781014523E-02 1.63791014501E-02 1.65825691839E-02 1.67885342058E-02 1.69970264025E-02 1.72080759989E-02 1.74217135616E-02 1.76379700018E-02 1.78568765789E-02 1.80784649041E-02 1.83027669432E-02 1.85298150206E-02 1.87596418223E-02 1.89922803998E-02 1.92277641731E-02 1.94661269342E-02 1.97074028511E-02 1.99516264708E-02 2.01988327229E-02 2.04490569233E-02 2.07023347776E-02 2.09587023849E-02 2.12181962409E-02 2.14808532420E-02 2.17467106885E-02 2.20158062885E-02 2.22881781613E-02 2.25638648411E-02 2.28429052806E-02 2.31253388547E-02 2.34112053642E-02 2.37005450391E-02 2.39933985427E-02 2.42898069749E-02 2.45898118761E-02 2.48934552308E-02 2.52007794712E-02 2.55118274806E-02 2.58266425978E-02 2.61452686198E-02 2.64677498064E-02 2.67941308829E-02 2.71244570445E-02 2.74587739596E-02 2.77971277733E-02 2.81395651113E-02 2.84861330832E-02 2.88368792864E-02 2.91918518092E-02 2.95510992349E-02 2.99146706450E-02 3.02826156226E-02 3.06549842562E-02 3.10318271430E-02 3.14131953922E-02 3.17991406288E-02 3.21897149964E-02 3.25849711611E-02 3.29849623144E-02 3.33897421769E-02 3.37993650010E-02 3.42138855744E-02 3.46333592234E-02 3.50578418158E-02 3.54873897636E-02 3.59220600269E-02 3.63619101160E-02 3.68069980947E-02 3.72573825830E-02 3.77131227599E-02 3.81742783662E-02 3.86409097070E-02 3.91130776544E-02 3.95908436497E-02 4.00742697062E-02 4.05634184112E-02 4.10583529285E-02 4.15591370003E-02 4.20658349494E-02 4.25785116811E-02 4.30972326853E-02 4.36220640378E-02 4.41530724024E-02 4.46903250319E-02 4.52338897701E-02 4.57838350527E-02 4.63402299087E-02 4.69031439611E-02 4.74726474281E-02 4.80488111237E-02 4.86317064583E-02 4.92214054392E-02 4.98179806708E-02 5.04215053549E-02 5.10320532904E-02 5.16496988733E-02 5.22745170959E-02 5.29065835470E-02 5.35459744102E-02 5.41927664633E-02 5.48470370775E-02 5.55088642151E-02 5.61783264286E-02 5.68555028587E-02 5.75404732318E-02 5.82333178581E-02 5.89341176287E-02 5.96429540132E-02 6.03599090559E-02 6.10850653727E-02 6.18185061478E-02 6.25603151290E-02 6.33105766240E-02 6.40693754956E-02 6.48367971565E-02 6.56129275645E-02 6.63978532168E-02 6.71916611438E-02 6.79944389031E-02 6.88062745726E-02 6.96272567437E-02 7.04574745137E-02 7.12970174778E-02 7.21459757210E-02 7.30044398097E-02 7.38725007820E-02 7.47502501384E-02 7.56377798319E-02 7.65351822571E-02 7.74425502397E-02 7.83599770246E-02 7.92875562637E-02 8.02253820041E-02 8.11735486742E-02 8.21321510704E-02 8.31012843430E-02 8.40810439809E-02 8.50715257968E-02 8.60728259108E-02 8.70850407335E-02 8.81082669493E-02 8.91426014979E-02 9.01881415557E-02 9.12449845166E-02 9.23132279719E-02 9.33929696893E-02 9.44843075912E-02 9.55873397329E-02 9.67021642789E-02 9.78288794790E-02 9.89675836440E-02 1.00118375119E-01 1.01281352259E-01 1.02456613398E-01 1.03644256825E-01 1.04844380751E-01 1.06057083280E-01 1.07282462380E-01 1.08520615848E-01 1.09771641278E-01 1.11035636025E-01 1.12312697174E-01 1.13602921499E-01 1.14906405427E-01 1.16223245001E-01 1.17553535839E-01 1.18897373093E-01 1.20254851403E-01 1.21626064863E-01 1.23011106967E-01 1.24410070567E-01 1.25823047824E-01 1.27250130164E-01 1.28691408221E-01 1.30146971789E-01 1.31616909772E-01 1.33101310123E-01 1.34600259794E-01 1.36113844677E-01 1.37642149542E-01 1.39185257981E-01 1.40743252345E-01 1.42316213675E-01 1.43904221646E-01 1.45507354491E-01 1.47125688937E-01 1.48759300134E-01 1.50408261582E-01 1.52072645054E-01 1.53752520526E-01 1.55447956094E-01 1.57159017896E-01 1.58885770029E-01 1.60628274469E-01 1.62386590977E-01 1.64160777023E-01 1.65950887683E-01 1.67756975557E-01 1.69579090669E-01 1.71417280375E-01 1.73271589260E-01 1.75142059037E-01 1.77028728450E-01 1.78931633162E-01 1.80850805647E-01 1.82786275086E-01 1.84738067248E-01 1.86706204378E-01 1.88690705078E-01 1.90691584188E-01 1.92708852663E-01 1.94742517446E-01 1.96792581344E-01 1.98859042895E-01 2.00941896233E-01 2.03041130957E-01 2.05156731988E-01 2.07288679430E-01 2.09436948427E-01 2.11601509012E-01 2.13782325962E-01 2.15979358643E-01 2.18192560853E-01 2.20421880670E-01 2.22667260282E-01 2.24928635830E-01 2.27205937238E-01 2.29499088042E-01 2.31808005221E-01 2.34132599016E-01 2.36472772753E-01 2.38828422662E-01 2.41199437692E-01 2.43585699319E-01 2.45987081361E-01 2.48403449778E-01 2.50834662480E-01 2.53280569121E-01 2.55741010900E-01 2.58215820355E-01 2.60704821148E-01 2.63207827861E-01 2.65724645773E-01 2.68255070646E-01 2.70798888501E-01 2.73355875397E-01 2.75925797201E-01 2.78508409359E-01 2.81103456661E-01 2.83710673010E-01 2.86329781180E-01 2.88960492573E-01 2.91602506981E-01 2.94255512332E-01 2.96919184449E-01 2.99593186791E-01 3.02277170204E-01 3.04970772662E-01 3.07673619009E-01 3.10385320699E-01 3.13105475532E-01 3.15833667389E-01 3.18569465966E-01 3.21312426503E-01 3.24062089516E-01 3.26817980525E-01 3.29579609779E-01 3.32346471979E-01 3.35118046010E-01 3.37893794653E-01 3.40673164315E-01 3.43455584749E-01 3.46240468770E-01 3.49027211982E-01 3.51815192492E-01 3.54603770633E-01 3.57392288685E-01 3.60180070594E-01 3.62966421691E-01 3.65750628419E-01 3.68531958051E-01 3.71309658417E-01 3.74082957628E-01 3.76851063806E-01 3.79613164811E-01 3.82368427972E-01 3.85115999827E-01 3.87855005852E-01 3.90584550209E-01 3.93303715488E-01 3.96011562451E-01 3.98707129791E-01 4.01389433884E-01 4.04057468551E-01 4.06710204829E-01 4.09346590737E-01 4.11965551064E-01 4.14565987143E-01 4.17146776655E-01 4.19706773419E-01 4.22244807205E-01 4.24759683548E-01 4.27250183571E-01 4.29715063821E-01 4.32153056111E-01 4.34562867372E-01 4.36943179521E-01 4.39292649331E-01 4.41609908323E-01 4.43893562662E-01 4.46142193072E-01 4.48354354760E-01 4.50528577356E-01 4.52663364867E-01 4.54757195651E-01 4.56808522394E-01 4.58815772124E-01 4.60777346218E-01 4.62691620448E-01 4.64556945035E-01 4.66371644721E-01 4.68134018865E-01 4.69842341563E-01 4.71494861778E-01 4.73089803503E-01 4.74625365941E-01 4.76099723711E-01 4.77511027079E-01 4.78857402208E-01 4.80136951444E-01 4.81347753618E-01 4.82487864383E-01 4.83555316579E-01 4.84548120619E-01 4.85464264915E-01 4.86301716328E-01 4.87058420654E-01 4.87732303137E-01 4.88321269021E-01 4.88823204132E-01 4.89235975495E-01 4.89557431990E-01 4.89785405040E-01 4.89917709342E-01 4.89952143629E-01 4.89886491477E-01 4.89718522152E-01 4.89445991493E-01 4.89066642838E-01 4.88578207999E-01 4.87978408273E-01 4.87264955494E-01 4.86435553146E-01 4.85487897500E-01 4.84419678815E-01 4.83228582577E-01 4.81912290790E-01 4.80468483315E-01 4.78894839253E-01 4.77189038389E-01 4.75348762679E-01 4.73371697788E-01 4.71255534684E-01 4.68997971283E-01 4.66596714147E-01 4.64049480236E-01 4.61353998714E-01 4.58508012808E-01 4.55509281726E-01 4.52355582626E-01 4.49044712642E-01 4.45574490969E-01 4.41942760996E-01 4.38147392504E-01 4.34186283917E-01 4.30057364602E-01 4.25758597238E-01 4.21287980227E-01 4.16643550171E-01 4.11823384398E-01 4.06825603546E-01 4.01648374194E-01 3.96289911557E-01 3.90748482225E-01 3.85022406953E-01 3.79110063509E-01 3.73009889567E-01 3.66720385642E-01 3.60240118085E-01 3.53567722108E-01 3.46701904868E-01 3.39641448579E-01 3.32385213673E-01 3.24932141993E-01 3.17281260029E-01 3.09431682177E-01 3.01382614042E-01 2.93133355754E-01 2.84683305327E-01 2.76031962025E-01 2.67178929762E-01 2.58123920509E-01 2.48866757723E-01 2.39407379782E-01 2.29745843435E-01 2.19882327245E-01 2.09817135051E-01 1.99550699415E-01 1.89083585073E-01 1.78416492374E-01 1.67550260711E-01 1.56485871941E-01 1.45224453785E-01 1.33767283211E-01 1.22115789796E-01 1.10271559062E-01 9.82363357901E-02 8.60120272967E-02 7.36007066867E-02 6.10046160679E-02 4.82261697297E-02 3.52679572829E-02 2.21327467575E-02 8.82348765564E-03 -4.65668604372E-03 -1.83044529317E-02 -3.21163012728E-02 -4.60885261696E-02 -6.02172267944E-02 -7.44983036961E-02 -8.89274561895E-02 -1.03500179839E-01 -1.18211764048E-01 -1.33057289771E-01 -1.48031627363E-01 -1.63129434596E-01 -1.78345154859E-01 -1.93673015582E-01 -2.09107026925E-01 -2.24640980769E-01 -2.40268450076E-01 -2.55982788681E-01 -2.71777131601E-01 -2.87644395950E-01 -3.03577282571E-01 -3.19568278513E-01 -3.35609660484E-01 -3.51693499434E-01 -3.67811666404E-01 -3.83955839789E-01 -4.00117514107E-01 -4.16288010340E-01 -4.32458487791E-01 -4.48619957306E-01 -4.64763295495E-01 -4.80879259403E-01 -4.96958500798E-01 -5.12991578985E-01 -5.28968970799E-01 -5.44881076246E-01 -5.60718218223E-01 -5.76470634884E-01 -5.92128463615E-01 -6.07681716210E-01 -6.23120245739E-01 -6.38433706603E-01 -6.53611510299E-01 -6.68642780341E-01 -6.83516310311E-01 -6.98220529194E-01 -7.12743477682E-01 -7.27072798244E-01 -7.41195740357E-01 -7.55099180643E-01 -7.68769656093E-01 -7.82193407204E-01 -7.95356427086E-01 -8.08244512452E-01 -8.20843312841E-01 -8.33138375321E-01 -8.45115183013E-01 -8.56759186828E-01 -8.68055830684E-01 -8.78990571075E-01 -8.89548892152E-01 -8.99716317586E-01 -9.09478420370E-01 -9.18820831563E-01 -9.27729248769E-01 -9.36189444916E-01 -9.44187277758E-01 -9.51708700312E-01 -9.58739772400E-01 -9.65266673301E-01 -9.71275715524E-01 -9.76753359615E-01 -9.81686229913E-01 -9.86061131138E-01 -9.89865065692E-01 -9.93085251531E-01 -9.95709140498E-01 -9.97724436973E-01 -9.99119116736E-01 -9.99881445925E-01 -1.00000000000E+00 -9.99463682609E-01 -9.98261744297E-01 -9.96383800981E-01 -9.93819852131E-01 -9.90560298623E-01 -9.86595960217E-01 -9.81918092627E-01 -9.76518404169E-01 -9.70389071957E-01 -9.63522757636E-01 -9.55912622643E-01 -9.47552342989E-01 -9.38436123538E-01 -9.28558711809E-01 -9.17915411264E-01 -9.06502094095E-01 -8.94315213507E-01 -8.81351815483E-01 -8.67609550037E-01 -8.53086681938E-01 -8.37782100914E-01 -8.21695331317E-01 -8.04826541246E-01 -7.87176551125E-01 -7.68746841721E-01 -7.49539561587E-01 -7.29557533937E-01 -7.08804262922E-01 -6.87283939294E-01 -6.65001445462E-01 -6.41962359901E-01 -6.18172960905E-01 -5.93640229670E-01 -5.68371852678E-01 -5.42376223359E-01 -5.15662443017E-01 -4.88240320984E-01 -4.60120373986E-01 -4.31313824681E-01 -4.01832599361E-01 -3.71689324769E-01 -3.40897324029E-01 -3.09470611639E-01 -2.77423887523E-01 -2.44772530113E-01 -2.11532588448E-01 -1.77720773274E-01 -1.43354447144E-01 -1.08451613526E-01 -7.30309049079E-02 -3.71115699535E-02 -7.13459709935E-04 3.61429870688E-02 7.34367594315E-02 1.11146290499E-01 1.49249474405E-01 1.87723683807E-01 2.26545787849E-01 2.65692170442E-01 3.05138748727E-01 3.44860991548E-01 3.84833937789E-01 4.25032214391E-01 4.65430053888E-01 5.06001311282E-01 5.46719480102E-01 5.87557707486E-01 6.28488808168E-01 6.69485277237E-01 7.10519301599E-01 7.51562770079E-01 7.92587282152E-01 8.33564155322E-01 8.74464431230E-01 9.15258880583E-01 9.55918007090E-01 9.96412050601E-01 1.03671098971E+00 1.07678454415E+00 1.11660217726E+00 1.15613309902E+00 1.19534626995E+00 1.23421040648E+00 1.27269398804E+00 1.31076526664E+00 1.34839227910E+00 1.38554286279E+00 1.42218467495E+00 1.45828521642E+00 1.49381185983E+00 1.52873188295E+00 1.56301250723E+00 1.59662094194E+00 1.62952443402E+00 1.66169032370E+00 1.69308610593E+00 1.72367949749E+00 1.75343850956E+00 1.78233152543E+00 1.81032738306E+00 1.83739546179E+00 1.86350577279E+00 1.88862905248E+00 1.91273685811E+00 1.93580166489E+00 1.95779696351E+00 1.97869735749E+00 1.99847865914E+00 2.01711798343E+00 2.03459383885E+00 2.05088621432E+00 2.06597666138E+00 2.07984837101E+00 2.09248624430E+00 2.10387695639E+00 2.11400901326E+00 2.12287280093E+00 2.13046062674E+00 2.13676675255E+00 2.14178741975E+00 2.14552086602E+00 2.14796733394E+00 2.14912907158E+00 2.14901032533E+00 2.14761732514E+00 2.14495826262E+00 2.14104326232E+00 2.13588434650E+00 2.12949539407E+00 2.12189209383E+00 2.11309189276E+00 2.10311393964E+00 2.09197902453E+00 2.07970951458E+00 2.06632928656E+00 2.05186365665E+00 2.03633930773E+00 2.01978421475E+00 2.00222756847E+00 1.98369969787E+00 1.96423199169E+00 1.94385681927E+00 1.92260745110E+00 1.90051797922E+00 1.87762323788E+00 1.85395872449E+00 1.82956052117E+00 1.80446521713E+00 1.77870983196E+00 1.75233173995E+00 1.72536859576E+00 1.69785826132E+00 1.66983873429E+00 1.64134807804E+00 1.61242435323E+00 1.58310555122E+00 1.55342952920E+00 1.52343394719E+00 1.49315620696E+00 1.46263339292E+00 1.43190221497E+00 1.40099895341E+00 1.36995940593E+00 1.33881883661E+00 1.30761192717E+00 1.27637273020E+00 1.24513462466E+00 1.21393027343E+00 1.18279158313E+00 1.15174966607E+00 1.12083480436E+00 1.09007641621E+00 1.05950302451E+00 1.02914222746E+00 9.99020671463E-01 9.69164026220E-01 9.39596961950E-01 9.10343128820E-01 8.81425138533E-01 8.52864548076E-01 8.24681845613E-01 7.96896438527E-01 7.69526643571E-01 7.42589679143E-01 7.16101659648E-01 6.90077591933E-01 6.64531373780E-01 6.39475794424E-01 6.14922537084E-01 5.90882183454E-01 5.67364220157E-01 5.44377047085E-01 5.21927987626E-01 5.00023300695E-01 4.78668194614E-01 4.57868964218E-01 4.37637532207E-01 4.17982177982E-01 3.98898058657E-01 3.80386101746E-01 3.62444383567E-01 3.45070513072E-01 3.28261317654E-01 3.12012890536E-01 2.96320613915E-01 2.81179183229E-01 2.66582632959E-01 2.52524363836E-01 2.38997171345E-01 2.25993275414E-01 2.13504351187E-01 2.01521560744E-01 1.90035585668E-01 1.79036660315E-01 1.68514605683E-01 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1.50 1.50 -1.83202331776E-04 -1.85507268505E-04 -1.87841197770E-04 -1.90204484251E-04 -1.92597497216E-04 -1.95020610579E-04 -1.97474202956E-04 -1.99958657726E-04 -2.02474363089E-04 -2.05021712130E-04 -2.07601102878E-04 -2.10212938368E-04 -2.12857626703E-04 -2.15535581123E-04 -2.18247220062E-04 -2.20992967220E-04 -2.23773251626E-04 -2.26588507705E-04 -2.29439175345E-04 -2.32325699970E-04 -2.35248532606E-04 -2.38208129949E-04 -2.41204954445E-04 -2.44239474352E-04 -2.47312163821E-04 -2.50423502965E-04 -2.53573977938E-04 -2.56764081008E-04 -2.59994310634E-04 -2.63265171547E-04 -2.66577174825E-04 -2.69930837976E-04 -2.73326685017E-04 -2.76765246555E-04 -2.80247059872E-04 -2.83772669009E-04 -2.87342624850E-04 -2.90957485207E-04 -2.94617814910E-04 -2.98324185893E-04 -3.02077177283E-04 -3.05877375494E-04 -3.09725374313E-04 -3.13621774999E-04 -3.17567186372E-04 -3.21562224911E-04 -3.25607514848E-04 -3.29703688268E-04 -3.33851385207E-04 -3.38051253751E-04 -3.42303950137E-04 -3.46610138859E-04 -3.50970492767E-04 -3.55385693175E-04 -3.59856429967E-04 -3.64383401705E-04 -3.68967315737E-04 -3.73608888309E-04 -3.78308844677E-04 -3.83067919218E-04 -3.87886855548E-04 -3.92766406634E-04 -3.97707334916E-04 -4.02710412426E-04 -4.07776420903E-04 -4.12906151921E-04 -4.18100407013E-04 -4.23359997790E-04 -4.28685746074E-04 -4.34078484025E-04 -4.39539054268E-04 -4.45068310029E-04 -4.50667115266E-04 -4.56336344802E-04 -4.62076884467E-04 -4.67889631231E-04 -4.73775493348E-04 -4.79735390496E-04 -4.85770253921E-04 -4.91881026582E-04 -4.98068663301E-04 -5.04334130908E-04 -5.10678408394E-04 -5.17102487067E-04 -5.23607370702E-04 -5.30194075699E-04 -5.36863631246E-04 -5.43617079473E-04 -5.50455475620E-04 -5.57379888201E-04 -5.64391399169E-04 -5.71491104087E-04 -5.78680112299E-04 -5.85959547101E-04 -5.93330545920E-04 -6.00794260489E-04 -6.08351857029E-04 -6.16004516430E-04 -6.23753434435E-04 -6.31599821829E-04 -6.39544904625E-04 -6.47589924258E-04 -6.55736137780E-04 -6.63984818053E-04 -6.72337253949E-04 -6.80794750553E-04 -6.89358629368E-04 -6.98030228515E-04 -7.06810902950E-04 -7.15702024672E-04 -7.24704982935E-04 -7.33821184471E-04 -7.43052053704E-04 -7.52399032976E-04 -7.61863582772E-04 -7.71447181946E-04 -7.81151327956E-04 -7.90977537094E-04 -8.00927344725E-04 -8.11002305527E-04 -8.21203993732E-04 -8.31534003375E-04 -8.41993948541E-04 -8.52585463617E-04 -8.63310203550E-04 -8.74169844100E-04 -8.85166082110E-04 -8.96300635763E-04 -9.07575244857E-04 -9.18991671070E-04 -9.30551698244E-04 -9.42257132655E-04 -9.54109803301E-04 -9.66111562187E-04 -9.78264284610E-04 -9.90569869459E-04 -1.00303023951E-03 -1.01564734171E-03 -1.02842314751E-03 -1.04135965317E-03 -1.05445888003E-03 -1.06772287487E-03 -1.08115371022E-03 -1.09475348468E-03 -1.10852432324E-03 -1.12246837761E-03 -1.13658782659E-03 -1.15088487637E-03 -1.16536176089E-03 -1.18002074219E-03 -1.19486411076E-03 -1.20989418592E-03 -1.22511331615E-03 -1.24052387946E-03 -1.25612828378E-03 -1.27192896733E-03 -1.28792839901E-03 -1.30412907875E-03 -1.32053353795E-03 -1.33714433983E-03 -1.35396407986E-03 -1.37099538617E-03 -1.38824091992E-03 -1.40570337578E-03 -1.42338548227E-03 -1.44129000227E-03 -1.45941973339E-03 -1.47777750844E-03 -1.49636619586E-03 -1.51518870016E-03 -1.53424796240E-03 -1.55354696064E-03 -1.57308871037E-03 -1.59287626503E-03 -1.61291271647E-03 -1.63320119542E-03 -1.65374487200E-03 -1.67454695619E-03 -1.69561069837E-03 -1.71693938979E-03 -1.73853636309E-03 -1.76040499285E-03 -1.78254869608E-03 -1.80497093278E-03 -1.82767520647E-03 -1.85066506474E-03 -1.87394409979E-03 -1.89751594902E-03 -1.92138429558E-03 -1.94555286895E-03 -1.97002544551E-03 -1.99480584914E-03 -2.01989795185E-03 -2.04530567431E-03 -2.07103298654E-03 -2.09708390847E-03 -2.12346251061E-03 -2.15017291467E-03 -2.17721929421E-03 -2.20460587527E-03 -2.23233693706E-03 -2.26041681261E-03 -2.28884988946E-03 -2.31764061032E-03 -2.34679347382E-03 -2.37631303512E-03 -2.40620390673E-03 -2.43647075915E-03 -2.46711832164E-03 -2.49815138293E-03 -2.52957479200E-03 -2.56139345882E-03 -2.59361235511E-03 -2.62623651514E-03 -2.65927103649E-03 -2.69272108088E-03 -2.72659187493E-03 -2.76088871102E-03 -2.79561694810E-03 -2.83078201251E-03 -2.86638939887E-03 -2.90244467090E-03 -2.93895346229E-03 -2.97592147763E-03 -3.01335449321E-03 -3.05125835804E-03 -3.08963899465E-03 -3.12850240009E-03 -3.16785464684E-03 -3.20770188375E-03 -3.24805033705E-03 -3.28890631123E-03 -3.33027619013E-03 -3.37216643786E-03 -3.41458359985E-03 -3.45753430385E-03 -3.50102526100E-03 -3.54506326683E-03 -3.58965520236E-03 -3.63480803516E-03 -3.68052882044E-03 -3.72682470215E-03 -3.77370291410E-03 -3.82117078110E-03 -3.86923572009E-03 -3.91790524130E-03 -3.96718694942E-03 -4.01708854480E-03 -4.06761782466E-03 -4.11878268427E-03 -4.17059111825E-03 -4.22305122174E-03 -4.27617119172E-03 -4.32995932828E-03 -4.38442403590E-03 -4.43957382479E-03 -4.49541731218E-03 -4.55196322372E-03 -4.60922039480E-03 -4.66719777194E-03 -4.72590441419E-03 -4.78534949458E-03 -4.84554230147E-03 -4.90649224011E-03 -4.96820883400E-03 -5.03070172646E-03 -5.09398068211E-03 -5.15805558837E-03 -5.22293645705E-03 -5.28863342587E-03 -5.35515676010E-03 -5.42251685409E-03 -5.49072423296E-03 -5.55978955421E-03 -5.62972360940E-03 -5.70053732583E-03 -5.77224176822E-03 -5.84484814050E-03 -5.91836778753E-03 -5.99281219683E-03 -6.06819300044E-03 -6.14452197673E-03 -6.22181105218E-03 -6.30007230332E-03 -6.37931795856E-03 -6.45956040014E-03 -6.54081216603E-03 -6.62308595192E-03 -6.70639461318E-03 -6.79075116689E-03 -6.87616879386E-03 -6.96266084069E-03 -7.05024082184E-03 -7.13892242178E-03 -7.22871949712E-03 -7.31964607872E-03 -7.41171637396E-03 -7.50494476891E-03 -7.59934583059E-03 -7.69493430926E-03 -7.79172514069E-03 -7.88973344854E-03 -7.98897454668E-03 -8.08946394161E-03 -8.19121733487E-03 -8.29425062551E-03 -8.39857991255E-03 -8.50422149750E-03 -8.61119188693E-03 -8.71950779503E-03 -8.82918614621E-03 -8.94024407777E-03 -9.05269894256E-03 -9.16656831171E-03 -9.28186997734E-03 -9.39862195538E-03 -9.51684248837E-03 -9.63655004828E-03 -9.75776333946E-03 -9.88050130150E-03 -1.00047831122E-02 -1.01306281907E-02 -1.02580562001E-02 -1.03870870512E-02 -1.05177409050E-02 -1.06500381761E-02 -1.07839995360E-02 -1.09196459161E-02 -1.10569985111E-02 -1.11960787823E-02 -1.13369084610E-02 -1.14795095516E-02 -1.16239043355E-02 -1.17701153744E-02 -1.19181655136E-02 -1.20680778858E-02 -1.22198759147E-02 -1.23735833187E-02 -1.25292241143E-02 -1.26868226202E-02 -1.28464034612E-02 -1.30079915713E-02 -1.31716121987E-02 -1.33372909087E-02 -1.35050535885E-02 -1.36749264508E-02 -1.38469360377E-02 -1.40211092257E-02 -1.41974732288E-02 -1.43760556037E-02 -1.45568842535E-02 -1.47399874323E-02 -1.49253937494E-02 -1.51131321743E-02 -1.53032320406E-02 -1.54957230510E-02 -1.56906352815E-02 -1.58879991868E-02 -1.60878456043E-02 -1.62902057594E-02 -1.64951112703E-02 -1.67025941528E-02 -1.69126868253E-02 -1.71254221141E-02 -1.73408332583E-02 -1.75589539151E-02 -1.77798181648E-02 -1.80034605167E-02 -1.82299159139E-02 -1.84592197389E-02 -1.86914078196E-02 -1.89265164340E-02 -1.91645823169E-02 -1.94056426647E-02 -1.96497351418E-02 -1.98968978863E-02 -2.01471695160E-02 -2.04005891344E-02 -2.06571963366E-02 -2.09170312159E-02 -2.11801343699E-02 -2.14465469066E-02 -2.17163104511E-02 -2.19894671521E-02 -2.22660596881E-02 -2.25461312747E-02 -2.28297256707E-02 -2.31168871856E-02 -2.34076606859E-02 -2.37020916023E-02 -2.40002259371E-02 -2.43021102710E-02 -2.46077917705E-02 -2.49173181953E-02 -2.52307379058E-02 -2.55480998706E-02 -2.58694536740E-02 -2.61948495240E-02 -2.65243382599E-02 -2.68579713605E-02 -2.71958009519E-02 -2.75378798158E-02 -2.78842613975E-02 -2.82349998147E-02 -2.85901498654E-02 -2.89497670367E-02 -2.93139075138E-02 -2.96826281881E-02 -3.00559866667E-02 -3.04340412808E-02 -3.08168510955E-02 -3.12044759184E-02 -3.15969763092E-02 -3.19944135892E-02 -3.23968498508E-02 -3.28043479673E-02 -3.32169716023E-02 -3.36347852202E-02 -3.40578540960E-02 -3.44862443253E-02 -3.49200228350E-02 -3.53592573936E-02 -3.58040166213E-02 -3.62543700017E-02 -3.67103878917E-02 -3.71721415329E-02 -3.76397030627E-02 -3.81131455256E-02 -3.85925428843E-02 -3.90779700317E-02 -3.95695028021E-02 -4.00672179834E-02 -4.05711933289E-02 -4.10815075695E-02 -4.15982404258E-02 -4.21214726208E-02 -4.26512858924E-02 -4.31877630060E-02 -4.37309877676E-02 -4.42810450367E-02 -4.48380207396E-02 -4.54020018828E-02 -4.59730765669E-02 -4.65513339994E-02 -4.71368645098E-02 -4.77297595627E-02 -4.83301117725E-02 -4.89380149180E-02 -4.95535639567E-02 -5.01768550394E-02 -5.08079855258E-02 -5.14470539994E-02 -5.20941602824E-02 -5.27494054520E-02 -5.34128918557E-02 -5.40847231272E-02 -5.47650042030E-02 -5.54538413380E-02 -5.61513421227E-02 -5.68576154997E-02 -5.75727717806E-02 -5.82969226634E-02 -5.90301812495E-02 -5.97726620618E-02 -6.05244810619E-02 -6.12857556688E-02 -6.20566047768E-02 -6.28371487741E-02 -6.36275095614E-02 -6.44278105709E-02 -6.52381767857E-02 -6.60587347591E-02 -6.68896126342E-02 -6.77309401637E-02 -6.85828487306E-02 -6.94454713680E-02 -7.03189427801E-02 -7.12033993631E-02 -7.20989792264E-02 -7.30058222139E-02 -7.39240699260E-02 -7.48538657411E-02 -7.57953548385E-02 -7.67486842204E-02 -7.77140027350E-02 -7.86914610995E-02 -7.96812119234E-02 -8.06834097323E-02 -8.16982109919E-02 -8.27257741321E-02 -8.37662595715E-02 -8.48198297427E-02 -8.58866491169E-02 -8.69668842296E-02 -8.80607037065E-02 -8.91682782895E-02 -9.02897808631E-02 -9.14253864812E-02 -9.25752723940E-02 -9.37396180758E-02 -9.49186052523E-02 -9.61124179289E-02 -9.73212424191E-02 -9.85452673733E-02 -9.97846838079E-02 -1.01039685134E-01 -1.02310467190E-01 -1.03597228268E-01 -1.04900169145E-01 -1.06219493118E-01 -1.07555406030E-01 -1.08908116304E-01 -1.10277834977E-01 -1.11664775727E-01 -1.13069154912E-01 -1.14491191599E-01 -1.15931107600E-01 -1.17389127504E-01 -1.18865478713E-01 -1.20360391476E-01 -1.21874098925E-01 -1.23406837108E-01 -1.24958845030E-01 -1.26530364685E-01 -1.28121641095E-01 -1.29732922346E-01 -1.31364459627E-01 -1.33016507269E-01 -1.34689322779E-01 -1.36383166887E-01 -1.38098303576E-01 -1.39835000129E-01 -1.41593527168E-01 -1.43374158693E-01 -1.45177172122E-01 -1.47002848337E-01 -1.48851471725E-01 -1.50723330216E-01 -1.52618715331E-01 -1.54537922226E-01 -1.56481249729E-01 -1.58449000393E-01 -1.60441480536E-01 -1.62459000285E-01 -1.64501873626E-01 -1.66570418445E-01 -1.68664956578E-01 -1.70785813859E-01 -1.72933320160E-01 -1.75107809448E-01 -1.77309619827E-01 -1.79539093587E-01 -1.81796577255E-01 -1.84082421641E-01 -1.86396981889E-01 -1.88740617527E-01 -1.91113692518E-01 -1.93516575304E-01 -1.95949638864E-01 -1.98413260760E-01 -2.00907823190E-01 -2.03433713036E-01 -2.05991321916E-01 -2.08581046237E-01 -2.11203287243E-01 -2.13858451065E-01 -2.16546948776E-01 -2.19269196436E-01 -2.22025615146E-01 -2.24816631096E-01 -2.27642675614E-01 -2.30504185214E-01 -2.33401601647E-01 -2.36335371944E-01 -2.39305948466E-01 -2.42313788946E-01 -2.45359356536E-01 -2.48443119848E-01 -2.51565552994E-01 -2.54727135629E-01 -2.57928352984E-01 -2.61169695905E-01 -2.64451660882E-01 -2.67774750084E-01 -2.71139471381E-01 -2.74546338372E-01 -2.77995870402E-01 -2.81488592578E-01 -2.85025035783E-01 -2.88605736681E-01 -2.92231237717E-01 -2.95902087115E-01 -2.99618838862E-01 -3.03382052693E-01 -3.07192294065E-01 -3.11050134117E-01 -3.14956149630E-01 -3.18910922969E-01 -3.22915042021E-01 -3.26969100109E-01 -3.31073695907E-01 -3.35229433328E-01 -3.39436921406E-01 -3.43696774152E-01 -3.48009610395E-01 -3.52376053605E-01 -3.56796731688E-01 -3.61272276761E-01 -3.65803324897E-01 -3.70390515844E-01 -3.75034492714E-01 -3.79735901630E-01 -3.84495391347E-01 -3.89313612825E-01 -3.94191218760E-01 -3.99128863075E-01 -4.04127200346E-01 -4.09186885189E-01 -4.14308571571E-01 -4.19492912074E-01 -4.24740557069E-01 -4.30052153833E-01 -4.35428345572E-01 -4.40869770359E-01 -4.46377059978E-01 -4.51950838663E-01 -4.57591721726E-01 -4.63300314065E-01 -4.69077208542E-01 -4.74922984225E-01 -4.80838204471E-01 -4.86823414856E-01 -4.92879140930E-01 -4.99005885777E-01 -5.05204127384E-01 -5.11474315785E-01 -5.17816869982E-01 -5.24232174609E-01 -5.30720576335E-01 -5.37282379978E-01 -5.43917844319E-01 -5.50627177583E-01 -5.57410532576E-01 -5.64268001449E-01 -5.71199610066E-01 -5.78205311948E-01 -5.85284981770E-01 -5.92438408382E-01 -5.99665287321E-01 -6.06965212794E-01 -6.14337669083E-01 -6.21782021364E-01 -6.29297505889E-01 -6.36883219506E-01 -6.44538108479E-01 -6.52260956583E-01 -6.60050372437E-01 -6.67904776035E-01 -6.75822384455E-01 -6.83801196716E-01 -6.91838977741E-01 -6.99933241421E-01 -7.08081232739E-01 -7.16279908954E-01 -7.24525919819E-01 -7.32815586832E-01 -7.41144881524E-01 -7.49509402784E-01 -7.57904353254E-01 -7.66324514807E-01 -7.74764223173E-01 -7.83217341747E-01 -7.91677234677E-01 -8.00136739308E-01 -8.08588138106E-01 -8.17023130197E-01 -8.25432802684E-01 -8.33807601928E-01 -8.42137305021E-01 -8.50410991700E-01 -8.58617016981E-01 -8.66742984854E-01 -8.74775723381E-01 -8.82701261617E-01 -8.90504808774E-01 -8.98170736138E-01 -9.05682562237E-01 -9.13022941839E-01 -9.20173659377E-01 -9.27115627430E-01 -9.33828890930E-01 -9.40292637782E-01 -9.46485216580E-01 -9.52384162152E-01 -9.57966229601E-01 -9.63207437530E-01 -9.68083121080E-01 -9.72567995353E-01 -9.76636229708E-01 -9.80261533324E-01 -9.83417252269E-01 -9.86076478187E-01 -9.88212168486E-01 -9.89797277727E-01 -9.90804899643E-01 -9.91208418941E-01 -9.90981671743E-01 -9.90099113189E-01 -9.88535990376E-01 -9.86268518451E-01 -9.83274057332E-01 -9.79531286147E-01 -9.75020372175E-01 -9.69723130772E-01 -9.63623172505E-01 -9.56706033540E-01 -9.48959285248E-01 -9.40372618986E-01 -9.30937902153E-01 -9.20649201914E-01 -9.09502773425E-01 -8.97497010023E-01 -8.84632353716E-01 -8.70911165344E-01 -8.56337555092E-01 -8.40917175618E-01 -8.24656981836E-01 -8.07564963508E-01 -7.89649859143E-01 -7.70920862295E-01 -7.51387334214E-01 -7.31058539841E-01 -7.09943427265E-01 -6.88050473970E-01 -6.65387626142E-01 -6.41962359901E-01 -6.17781895077E-01 -5.92853581804E-01 -5.67185341232E-01 -5.40785798534E-01 -5.13664292875E-01 -4.85830877399E-01 -4.57296318407E-01 -4.28072093703E-01 -3.98170390089E-01 -3.67604099967E-01 -3.36386817040E-01 -3.04532831071E-01 -2.72057121688E-01 -2.38975351206E-01 -2.05303856456E-01 -1.71059639615E-01 -1.36260358015E-01 -1.00924312953E-01 -6.50704375026E-02 -2.87182833510E-02 8.11199330208E-03 4.53996467430E-02 8.31233575760E-02 1.21261249317E-01 1.59790905659E-01 1.98689388303E-01 2.37933255245E-01 2.77498579364E-01 3.17360967191E-01 3.57495577679E-01 3.97877140825E-01 4.38479975954E-01 4.79278009512E-01 5.20244792174E-01 5.61353515128E-01 6.02577025355E-01 6.43887839791E-01 6.85258158255E-01 7.26659875040E-01 7.68064589145E-01 8.09443613103E-01 8.50767980451E-01 8.92008451907E-01 9.33135520363E-01 9.74119414876E-01 1.01493010386E+00 1.05553729772E+00 1.09591045135E+00 1.13601876661E+00 1.17583119546E+00 1.21531644402E+00 1.25444297794E+00 1.29317902977E+00 1.33149260863E+00 1.36935151277E+00 1.40672334547E+00 1.44357553478E+00 1.47987535755E+00 1.51558996808E+00 1.55068643190E+00 1.58513176490E+00 1.61889297798E+00 1.65193712758E+00 1.68423137197E+00 1.71574303339E+00 1.74643966593E+00 1.77628912888E+00 1.80525966532E+00 1.83331998549E+00 1.86043935433E+00 1.88658768287E+00 1.91173562239E+00 1.93585466099E+00 1.95891722136E+00 1.98089675921E+00 2.00176786127E+00 2.02150634194E+00 2.04008933781E+00 2.05749539897E+00 2.07370457642E+00 2.08869850467E+00 2.10246047876E+00 2.11497552514E+00 2.12623046572E+00 2.13621397462E+00 2.14491662726E+00 2.15233094143E+00 2.15845141020E+00 2.16327452649E+00 2.16679879936E+00 2.16902476205E+00 2.16995497190E+00 2.16959400246E+00 2.16794842792E+00 2.16502680036E+00 2.16083962007E+00 2.15539929944E+00 2.14872012080E+00 2.14081818867E+00 2.13171137699E+00 2.12141927159E+00 2.10996310861E+00 2.09736570916E+00 2.08365141074E+00 2.06884599589E+00 2.05297661833E+00 2.03607172731E+00 2.01816099010E+00 1.99927521344E+00 1.97944626394E+00 1.95870698789E+00 1.93709113079E+00 1.91463325678E+00 1.89136866828E+00 1.86733332602E+00 1.84256376975E+00 1.81709703966E+00 1.79097059888E+00 1.76422225703E+00 1.73689009506E+00 1.70901239152E+00 1.68062755025E+00 1.65177402973E+00 1.62249027413E+00 1.59281464606E+00 1.56278536123E+00 1.53244042494E+00 1.50181757055E+00 1.47095419999E+00 1.43988732620E+00 1.40865351776E+00 1.37728884555E+00 1.34582883153E+00 1.31430839976E+00 1.28276182945E+00 1.25122271034E+00 1.21972390016E+00 1.18829748438E+00 1.15697473809E+00 1.12578609019E+00 1.09476108972E+00 1.06392837447E+00 1.03331564177E+00 1.00294962154E+00 9.72856051510E-01 9.43059654695E-01 9.13584119051E-01 8.84452079329E-01 8.55685101127E-01 8.27303667109E-01 7.99327165390E-01 7.71773880080E-01 7.44660983947E-01 7.18004533214E-01 6.91819464433E-01 6.66119593449E-01 6.40917616409E-01 6.16225112782E-01 5.92052550389E-01 5.68409292375E-01 5.45303606106E-01 5.22742673953E-01 5.00732605901E-01 4.79278453938E-01 4.58385480882E-01 4.38069162082E-01 4.18331493108E-01 3.99172246315E-01 3.80590383207E-01 3.62584070533E-01 3.45150698290E-01 3.28286899542E-01 3.11988572000E-01 2.96250901262E-01 2.81068385642E-01 2.66434862485E-01 2.52343535877E-01 2.38787005639E-01 2.25757297497E-01 2.13245894306E-01 2.01243768228E-01 1.89741413715E-01 1.78728881194E-01 1.68195811313E-01 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 -0.00000000000E+00 2P 1 2.97799966220E-07 3.04066780522E-07 3.10465471810E-07 3.16998815261E-07 3.23680045776E-07 3.30534345416E-07 3.37559918271E-07 3.44761793297E-07 3.52143991603E-07 3.59710654579E-07 3.67466020670E-07 3.75414433447E-07 3.83560419972E-07 3.91908587627E-07 4.00463458170E-07 4.09229776023E-07 4.18212551962E-07 4.27416826810E-07 4.36847788894E-07 4.46510776373E-07 4.56411250339E-07 4.66554800070E-07 4.76947158298E-07 4.87594208118E-07 4.98501970367E-07 5.09676620011E-07 5.21124503634E-07 5.32852117170E-07 5.44866104427E-07 5.57173284920E-07 5.69780662193E-07 5.82695407305E-07 5.95924861964E-07 6.09476557997E-07 6.23358212980E-07 6.37577737747E-07 6.52143240630E-07 6.67063032395E-07 6.82345631176E-07 6.97999768228E-07 7.14034395397E-07 7.30458686630E-07 7.47282037577E-07 7.64514084246E-07 7.82164706887E-07 8.00244023263E-07 8.18762404858E-07 8.37730482848E-07 8.57159153692E-07 8.77059592787E-07 8.97443247646E-07 9.18321848281E-07 9.39707428113E-07 9.61612315497E-07 9.84049142320E-07 1.00703085862E-06 1.03057073618E-06 1.05468237794E-06 1.07937972601E-06 1.10467707018E-06 1.13058905657E-06 1.15713069655E-06 1.18431737583E-06 1.21216486387E-06 1.24068932339E-06 1.26990732025E-06 1.29983583352E-06 1.33049226579E-06 1.36189445377E-06 1.39406067916E-06 1.42700967973E-06 1.46076066080E-06 1.49533330685E-06 1.53074779363E-06 1.56702480045E-06 1.60418552265E-06 1.64225168414E-06 1.68124555137E-06 1.72118994656E-06 1.76210826141E-06 1.80402447203E-06 1.84696315349E-06 1.89094949424E-06 1.93600931177E-06 1.98216906824E-06 2.02945588649E-06 2.07789756693E-06 2.12752260438E-06 2.17836020545E-06 2.23044030645E-06 2.28379359160E-06 2.33845151182E-06 2.39444630393E-06 2.45181101035E-06 2.51057949930E-06 2.57078648547E-06 2.63246755128E-06 2.69565916861E-06 2.76039872110E-06 2.82672452700E-06 2.89467586263E-06 2.96429298636E-06 3.03561716328E-06 3.10869069040E-06 3.18355692255E-06 3.26026029890E-06 3.33884637013E-06 3.41936182635E-06 3.50185452562E-06 3.58637352326E-06 3.67296910188E-06 3.76169280217E-06 3.85259745440E-06 3.94573721081E-06 4.04116757874E-06 4.13894545461E-06 4.23912915877E-06 4.34177847120E-06 4.44695466810E-06 4.55472055945E-06 4.66514052743E-06 4.77828056588E-06 4.89420832068E-06 5.01299313122E-06 5.13470607283E-06 5.25942000035E-06 5.38720959269E-06 5.51815139863E-06 5.65232388366E-06 5.78980747816E-06 5.93068462611E-06 6.07503983326E-06 6.22295972089E-06 6.37453308620E-06 6.52985095406E-06 6.68900662919E-06 6.85209574395E-06 7.01921632022E-06 7.19046884372E-06 7.36595631742E-06 7.54578432228E-06 7.73006108466E-06 7.91889754158E-06 8.11240740885E-06 8.31070725066E-06 8.51391655096E-06 8.72215778667E-06 8.93555650258E-06 9.15424138831E-06 9.37834435703E-06 9.60800062626E-06 9.84334880059E-06 1.00845309566E-05 1.03316927297E-05 1.05849834034E-05 1.08445560006E-05 1.11105673773E-05 1.13831783183E-05 1.16625536360E-05 1.19488622710E-05 1.22422773953E-05 1.25429765186E-05 1.28511415966E-05 1.31669591423E-05 1.34906203401E-05 1.38223211628E-05 1.41622624910E-05 1.45106502366E-05 1.48676954680E-05 1.52336145395E-05 1.56086292232E-05 1.59929668448E-05 1.63868604224E-05 1.67905488087E-05 1.72042768369E-05 1.76282954706E-05 1.80628619563E-05 1.85082399812E-05 1.89646998337E-05 1.94325185686E-05 1.99119801760E-05 2.04033757546E-05 2.09070036894E-05 2.14231698335E-05 2.19521876948E-05 2.24943786270E-05 2.30500720257E-05 2.36196055287E-05 2.42033252225E-05 2.48015858525E-05 2.54147510393E-05 2.60431935001E-05 2.66872952759E-05 2.73474479638E-05 2.80240529553E-05 2.87175216808E-05 2.94282758598E-05 3.01567477572E-05 3.09033804465E-05 3.16686280788E-05 3.24529561593E-05 3.32568418296E-05 3.40807741580E-05 3.49252544364E-05 3.57907964848E-05 3.66779269628E-05 3.75871856898E-05 3.85191259721E-05 3.94743149386E-05 4.04533338849E-05 4.14567786253E-05 4.24852598544E-05 4.35394035165E-05 4.46198511853E-05 4.57272604520E-05 4.68623053233E-05 4.80256766297E-05 4.92180824428E-05 5.04402485039E-05 5.16929186628E-05 5.29768553270E-05 5.42928399224E-05 5.56416733654E-05 5.70241765463E-05 5.84411908244E-05 5.98935785363E-05 6.13822235151E-05 6.29080316240E-05 6.44719313013E-05 6.60748741204E-05 6.77178353625E-05 6.94018146037E-05 7.11278363160E-05 7.28969504839E-05 7.47102332357E-05 7.65687874896E-05 7.84737436165E-05 8.04262601187E-05 8.24275243250E-05 8.44787531032E-05 8.65811935892E-05 8.87361239351E-05 9.09448540742E-05 9.32087265057E-05 9.55291170981E-05 9.79074359121E-05 1.00345128044E-04 1.02843674488E-04 1.05404593022E-04 1.08029439114E-04 1.10719806850E-04 1.13477329882E-04 1.16303682405E-04 1.19200580153E-04 1.22169781421E-04 1.25213088110E-04 1.28332346799E-04 1.31529449843E-04 1.34806336498E-04 1.38164994070E-04 1.41607459094E-04 1.45135818544E-04 1.48752211068E-04 1.52458828253E-04 1.56257915926E-04 1.60151775477E-04 1.64142765223E-04 1.68233301801E-04 1.72425861591E-04 1.76722982180E-04 1.81127263855E-04 1.85641371138E-04 1.90268034350E-04 1.95010051221E-04 1.99870288530E-04 2.04851683792E-04 2.09957246982E-04 2.15190062297E-04 2.20553289964E-04 2.26050168094E-04 2.31684014571E-04 2.37458228993E-04 2.43376294661E-04 2.49441780607E-04 2.55658343676E-04 2.62029730660E-04 2.68559780473E-04 2.75252426389E-04 2.82111698323E-04 2.89141725175E-04 2.96346737220E-04 3.03731068560E-04 3.11299159638E-04 3.19055559798E-04 3.27004929921E-04 3.35152045108E-04 3.43501797443E-04 3.52059198800E-04 3.60829383735E-04 3.69817612437E-04 3.79029273742E-04 3.88469888235E-04 3.98145111403E-04 4.08060736879E-04 4.18222699751E-04 4.28637079955E-04 4.39310105738E-04 4.50248157213E-04 4.61457769984E-04 4.72945638867E-04 4.84718621687E-04 4.96783743166E-04 5.09148198907E-04 5.21819359458E-04 5.34804774479E-04 5.48112177001E-04 5.61749487782E-04 5.75724819765E-04 5.90046482637E-04 6.04722987491E-04 6.19763051598E-04 6.35175603279E-04 6.50969786903E-04 6.67154967981E-04 6.83740738390E-04 7.00736921705E-04 7.18153578659E-04 7.36001012722E-04 7.54289775804E-04 7.73030674094E-04 7.92234774023E-04 8.11913408360E-04 8.32078182453E-04 8.52740980598E-04 8.73913972560E-04 8.95609620233E-04 9.17840684453E-04 9.40620231951E-04 9.63961642480E-04 9.87878616076E-04 1.01238518050E-03 1.03749569882E-03 1.06322487720E-03 1.08958777281E-03 1.11659980193E-03 1.14427674826E-03 1.17263477135E-03 1.20169041528E-03 1.23146061748E-03 1.26196271774E-03 1.29321446747E-03 1.32523403908E-03 1.35804003562E-03 1.39165150064E-03 1.42608792814E-03 1.46136927293E-03 1.49751596101E-03 1.53454890032E-03 1.57248949163E-03 1.61135963969E-03 1.65118176464E-03 1.69197881358E-03 1.73377427247E-03 1.77659217826E-03 1.82045713119E-03 1.86539430746E-03 1.91142947212E-03 1.95858899217E-03 2.00689984998E-03 2.05638965704E-03 2.10708666785E-03 2.15901979421E-03 2.21221861978E-03 2.26671341486E-03 2.32253515158E-03 2.37971551929E-03 2.43828694034E-03 2.49828258610E-03 2.55973639337E-03 2.62268308103E-03 2.68715816712E-03 2.75319798617E-03 2.82083970687E-03 2.89012135017E-03 2.96108180759E-03 3.03376086003E-03 3.10819919684E-03 3.18443843525E-03 3.26252114026E-03 3.34249084479E-03 3.42439207030E-03 3.50827034775E-03 3.59417223892E-03 3.68214535821E-03 3.77223839475E-03 3.86450113499E-03 3.95898448561E-03 4.05574049694E-03 4.15482238675E-03 4.25628456445E-03 4.36018265573E-03 4.46657352769E-03 4.57551531430E-03 4.68706744239E-03 4.80129065806E-03 4.91824705352E-03 5.03800009443E-03 5.16061464766E-03 5.28615700953E-03 5.41469493453E-03 5.54629766445E-03 5.68103595813E-03 5.81898212148E-03 5.96021003818E-03 6.10479520073E-03 6.25281474208E-03 6.40434746767E-03 6.55947388802E-03 6.71827625183E-03 6.88083857948E-03 7.04724669715E-03 7.21758827140E-03 7.39195284418E-03 7.57043186846E-03 7.75311874431E-03 7.94010885544E-03 8.13149960634E-03 8.32739045986E-03 8.52788297529E-03 8.73308084697E-03 8.94308994344E-03 9.15801834695E-03 9.37797639366E-03 9.60307671417E-03 9.83343427461E-03 1.00691664183E-02 1.03103929075E-02 1.05572359666E-02 1.08098203243E-02 1.10682732577E-02 1.13327246359E-02 1.16033069646E-02 1.18801554309E-02 1.21634079482E-02 1.24532052026E-02 1.27496906982E-02 1.30530108042E-02 1.33633148018E-02 1.36807549309E-02 1.40054864384E-02 1.43376676261E-02 1.46774598985E-02 1.50250278122E-02 1.53805391245E-02 1.57441648426E-02 1.61160792733E-02 1.64964600727E-02 1.68854882961E-02 1.72833484484E-02 1.76902285343E-02 1.81063201088E-02 1.85318183282E-02 1.89669220005E-02 1.94118336361E-02 1.98667594991E-02 2.03319096581E-02 2.08074980366E-02 2.12937424644E-02 2.17908647279E-02 2.22990906206E-02 2.28186499939E-02 2.33497768069E-02 2.38927091765E-02 2.44476894269E-02 2.50149641390E-02 2.55947841990E-02 2.61874048472E-02 2.67930857258E-02 2.74120909260E-02 2.80446890351E-02 2.86911531825E-02 2.93517610849E-02 3.00267950914E-02 3.07165422264E-02 3.14212942331E-02 3.21413476152E-02 3.28770036773E-02 3.36285685651E-02 3.43963533032E-02 3.51806738327E-02 3.59818510468E-02 3.68002108249E-02 3.76360840659E-02 3.84898067187E-02 3.93617198121E-02 4.02521694821E-02 4.11615069979E-02 4.20900887853E-02 4.30382764483E-02 4.40064367886E-02 4.49949418228E-02 4.60041687964E-02 4.70345001965E-02 4.80863237605E-02 4.91600324834E-02 5.02560246211E-02 5.13747036907E-02 5.25164784688E-02 5.36817629848E-02 5.48709765122E-02 5.60845435556E-02 5.73228938339E-02 5.85864622603E-02 5.98756889176E-02 6.11910190297E-02 6.25329029286E-02 6.39017960170E-02 6.52981587267E-02 6.67224564713E-02 6.81751595946E-02 6.96567433139E-02 7.11676876573E-02 7.27084773969E-02 7.42796019744E-02 7.58815554228E-02 7.75148362807E-02 7.91799475010E-02 8.08773963533E-02 8.26076943191E-02 8.43713569809E-02 8.61689039041E-02 8.80008585114E-02 8.98677479501E-02 9.17701029519E-02 9.37084576847E-02 9.56833495966E-02 9.76953192513E-02 9.97449101558E-02 1.01832668579E-01 1.03959143360E-01 1.06124885713E-01 1.08330449012E-01 1.10576388582E-01 1.12863261462E-01 1.15191626173E-01 1.17562042470E-01 1.19975071084E-01 1.22431273451E-01 1.24931211437E-01 1.27475447043E-01 1.30064542110E-01 1.32699058002E-01 1.35379555284E-01 1.38106593385E-01 1.40880730254E-01 1.43702521997E-01 1.46572522508E-01 1.49491283081E-01 1.52459352022E-01 1.55477274231E-01 1.58545590785E-01 1.61664838503E-01 1.64835549499E-01 1.68058250720E-01 1.71333463472E-01 1.74661702936E-01 1.78043477665E-01 1.81479289071E-01 1.84969630898E-01 1.88514988685E-01 1.92115839208E-01 1.95772649916E-01 1.99485878349E-01 2.03255971548E-01 2.07083365448E-01 2.10968484254E-01 2.14911739816E-01 2.18913530981E-01 2.22974242937E-01 2.27094246541E-01 2.31273897642E-01 2.35513536384E-01 2.39813486503E-01 2.44174054613E-01 2.48595529476E-01 2.53078181267E-01 2.57622260825E-01 2.62227998896E-01 2.66895605369E-01 2.71625268496E-01 2.76417154110E-01 2.81271404831E-01 2.86188139269E-01 2.91167451209E-01 2.96209408804E-01 3.01314053748E-01 3.06481400451E-01 3.11711435201E-01 3.17004115331E-01 3.22359368368E-01 3.27777091187E-01 3.33257149152E-01 3.38799375263E-01 3.44403569283E-01 3.50069496878E-01 3.55796888733E-01 3.61585439683E-01 3.67434807823E-01 3.73344613619E-01 3.79314439016E-01 3.85343826536E-01 3.91432278368E-01 3.97579255458E-01 4.03784176585E-01 4.10046417432E-01 4.16365309649E-01 4.22740139906E-01 4.29170148942E-01 4.35654530596E-01 4.42192430843E-01 4.48782946807E-01 4.55425125781E-01 4.62117964232E-01 4.68860406807E-01 4.75651345334E-01 4.82489617830E-01 4.89374007514E-01 4.96303241830E-01 5.03275991491E-01 5.10290869553E-01 5.17346430518E-01 5.24441169500E-01 5.31573521445E-01 5.38741860438E-01 5.45944499122E-01 5.53179688240E-01 5.60445616344E-01 5.67740409712E-01 5.75062132503E-01 5.82408787225E-01 5.89778315564E-01 5.97168599656E-01 6.04577463894E-01 6.12002677363E-01 6.19441957023E-01 6.26892971757E-01 6.34353347418E-01 6.41820672994E-01 6.49292508020E-01 6.56766391301E-01 6.64239850994E-01 6.71710415974E-01 6.79175628329E-01 6.86633056617E-01 6.94080309357E-01 7.01515047946E-01 7.08934997951E-01 7.16337957465E-01 7.23721801010E-01 7.31084477403E-01 7.38424000056E-01 7.45738428514E-01 7.53025840605E-01 7.60284295378E-01 7.67511788032E-01 7.74706199102E-01 7.81865241191E-01 7.88986407250E-01 7.96066924771E-01 8.03103720072E-01 8.10093396103E-01 8.17032225971E-01 8.23916162762E-01 8.30740864495E-01 8.37501731452E-01 8.44193951944E-01 8.50812552024E-01 8.57352444804E-01 8.63808475714E-01 8.70175461191E-01 8.76448219465E-01 8.82621593277E-01 8.88690465161E-01 8.94649766517E-01 9.00494481884E-01 9.06219649844E-01 9.11820361846E-01 9.17291759961E-01 9.22629034396E-01 9.27827421317E-01 9.32882201343E-01 9.37788698948E-01 9.42542282856E-01 9.47138367458E-01 9.51572415212E-01 9.55839939949E-01 9.59936510986E-01 9.63857757955E-01 9.67599376202E-01 9.71157132672E-01 9.74526872149E-01 9.77704523754E-01 9.80686107610E-01 9.83467741581E-01 9.86045648008E-01 9.88416160387E-01 9.90575729929E-01 9.92520931954E-01 9.94248472087E-01 9.95755192235E-01 9.97038076313E-01 9.98094255715E-01 9.98921014517E-01 9.99515794411E-01 9.99876199361E-01 1.00000000000E+00 9.99885137752E-01 9.99529728694E-01 9.98932067169E-01 9.98090629140E-01 9.97004075317E-01 9.95671254034E-01 9.94091203911E-01 9.92263156285E-01 9.90186537436E-01 9.87860970593E-01 9.85286277747E-01 9.82462481259E-01 9.79389805278E-01 9.76068676971E-01 9.72499727561E-01 9.68683793193E-01 9.64621915614E-01 9.60315342681E-01 9.55765528691E-01 9.50974134540E-01 9.45943027710E-01 9.40674282076E-01 9.35170177549E-01 9.29433199530E-01 9.23466038192E-01 9.17271587572E-01 9.10852944474E-01 9.04213407168E-01 8.97356473885E-01 8.90285841090E-01 8.83005401524E-01 8.75519241996E-01 8.67831640918E-01 8.59947065549E-01 8.51870168950E-01 8.43605786605E-01 8.35158932708E-01 8.26534796071E-01 8.17738735649E-01 8.08776275641E-01 7.99653100158E-01 7.90375047413E-01 7.80948103448E-01 7.71378395335E-01 7.61672183880E-01 7.51835855782E-01 7.41875915268E-01 7.31798975194E-01 7.21611747623E-01 7.11321033887E-01 7.00933714174E-01 6.90456736657E-01 6.79897106219E-01 6.69261872809E-01 6.58558119509E-01 6.47792950363E-01 6.36973478052E-01 6.26106811490E-01 6.15200043438E-01 6.04260238215E-01 5.93294419606E-01 5.82309559055E-01 5.71312564240E-01 5.60310268113E-01 5.49309418489E-01 5.38316668263E-01 5.27338566322E-01 5.16381549204E-01 5.05451933560E-01 4.94555909453E-01 4.83699534512E-01 4.72888728954E-01 4.62129271469E-01 4.51426795963E-01 4.40786789110E-01 4.30214588689E-01 4.19715382645E-01 4.09294208818E-01 3.98955955260E-01 3.88705361066E-01 3.78547017625E-01 3.68485370218E-01 3.58524719840E-01 3.48669225182E-01 3.38922904651E-01 3.29289638354E-01 3.19773169947E-01 3.10377108276E-01 3.01104928724E-01 2.91959974214E-01 2.82945455796E-01 2.74064452790E-01 2.65319912457E-01 2.56714649163E-01 2.48251343057E-01 2.39932538259E-01 2.31760640588E-01 2.23737914870E-01 2.15866481869E-01 2.08148314899E-01 2.00585236201E-01 1.93178913131E-01 1.85930854268E-01 1.78842405507E-01 1.71914746230E-01 1.65148885632E-01 1.58545659293E-01 1.52105726066E-01 1.45829565357E-01 1.39717474862E-01 1.33769568821E-01 1.27985776835E-01 1.22365843297E-01 1.16909327453E-01 1.11615604132E-01 1.06483865153E-01 1.01513121410E-01 9.67022056381E-02 9.20497758471E-02 8.75543194069E-02 8.32141577557E-02 7.90274517054E-02 7.49922073066E-02 7.11062822351E-02 6.73673926559E-02 6.37731205205E-02 6.03209212484E-02 5.70081317454E-02 5.38319787078E-02 5.07895871621E-02 4.78779891921E-02 4.50941328022E-02 4.24348908696E-02 3.98970701388E-02 3.74774202134E-02 3.51726425013E-02 3.29793990733E-02 3.08943213954E-02 2.89140188999E-02 2.70350873598E-02 2.52541170377E-02 2.35677005784E-02 2.19724406211E-02 2.04649571084E-02 1.90418942703E-02 1.76999272666E-02 1.64357684727E-02 1.52461733964E-02 1.41279462143E-02 1.30779449225E-02 1.20930860942E-02 1.11703492427E-02 1.03067807877E-02 9.49949762696E-03 8.74569031575E-03 8.04262585898E-03 7.38765012264E-03 6.77818987255E-03 6.21175444977E-03 5.68593709366E-03 5.19841592434E-03 4.74695459779E-03 4.32940264740E-03 3.94369552689E-03 3.58785437002E-03 3.25998548308E-03 2.95827958683E-03 2.68101082460E-03 2.42653555370E-03 2.19329093725E-03 1.97979335372E-03 1.78463664131E-03 1.60649019392E-03 1.44409692562E-03 1.29627111964E-03 1.16189617785E-03 1.03992228603E-03 9.29364009460E-04 8.29297832927E-04 7.38859658367E-04 6.57242272480E-04 5.83692795871E-04 5.17510124200E-04 4.58042370993E-04 4.04686199123E-04 3.56888189496E-04 3.14133826281E-04 2.75936952735E-04 2.41854761089E-04 2.11477210544E-04 1.84426882310E-04 1.60356268200E-04 1.38945462388E-04 1.19899848780E-04 1.02947808754E-04 8.78384332198E-05 7.43392217131E-05 6.22337457274E-05 5.13192476022E-05 4.14041389590E-05 3.23053535993E-05 2.38454985093E-05 1.58497325226E-05 8.14228450505E-06 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1.50 1.50 7.80943327968E-08 8.00715127559E-08 8.20987426203E-08 8.41772894419E-08 8.63084523479E-08 8.84935633526E-08 9.07339881900E-08 9.30311271676E-08 9.53864160412E-08 9.78013269126E-08 1.00277369150E-07 1.02816090330E-07 1.05419077207E-07 1.08087956704E-07 1.10824396929E-07 1.13630108217E-07 1.16506844201E-07 1.19456402908E-07 1.22480627880E-07 1.25581409329E-07 1.28760685318E-07 1.32020442972E-07 1.35362719718E-07 1.38789604562E-07 1.42303239395E-07 1.45905820326E-07 1.49599599060E-07 1.53386884306E-07 1.57270043215E-07 1.61251502863E-07 1.65333751768E-07 1.69519341445E-07 1.73810888000E-07 1.78211073767E-07 1.82722648980E-07 1.87348433500E-07 1.92091318569E-07 1.96954268621E-07 2.01940323138E-07 2.07052598543E-07 2.12294290152E-07 2.17668674173E-07 2.23179109747E-07 2.28829041057E-07 2.34621999470E-07 2.40561605754E-07 2.46651572336E-07 2.52895705620E-07 2.59297908375E-07 2.65862182163E-07 2.72592629849E-07 2.79493458161E-07 2.86568980323E-07 2.93823618744E-07 3.01261907791E-07 3.08888496615E-07 3.16708152063E-07 3.24725761654E-07 3.32946336635E-07 3.41375015113E-07 3.50017065266E-07 3.58877888637E-07 3.67963023509E-07 3.77278148367E-07 3.86829085447E-07 3.96621804375E-07 4.06662425899E-07 4.16957225715E-07 4.27512638385E-07 4.38335261367E-07 4.49431859131E-07 4.60809367391E-07 4.72474897438E-07 4.84435740588E-07 4.96699372734E-07 5.09273459025E-07 5.22165858651E-07 5.35384629760E-07 5.48938034490E-07 5.62834544137E-07 5.77082844449E-07 5.91691841054E-07 6.06670665025E-07 6.22028678589E-07 6.37775480980E-07 6.53920914436E-07 6.70475070351E-07 6.87448295585E-07 7.04851198928E-07 7.22694657732E-07 7.40989824710E-07 7.59748134907E-07 7.78981312846E-07 7.98701379858E-07 8.18920661593E-07 8.39651795727E-07 8.60907739858E-07 8.82701779606E-07 9.05047536919E-07 9.27958978583E-07 9.51450424954E-07 9.75536558911E-07 1.00023243503E-06 1.02555348898E-06 1.05151554722E-06 1.07813483681E-06 1.10542799564E-06 1.13341208276E-06 1.16210458909E-06 1.19152344832E-06 1.22168704812E-06 1.25261424169E-06 1.28432435944E-06 1.31683722118E-06 1.35017314843E-06 1.38435297715E-06 1.41939807078E-06 1.45533033356E-06 1.49217222425E-06 1.52994677012E-06 1.56867758143E-06 1.60838886608E-06 1.64910544483E-06 1.69085276676E-06 1.73365692519E-06 1.77754467401E-06 1.82254344436E-06 1.86868136182E-06 1.91598726396E-06 1.96449071836E-06 2.01422204113E-06 2.06521231580E-06 2.11749341281E-06 2.17109800937E-06 2.22605960992E-06 2.28241256708E-06 2.34019210309E-06 2.39943433182E-06 2.46017628141E-06 2.52245591732E-06 2.58631216611E-06 2.65178493978E-06 2.71891516070E-06 2.78774478715E-06 2.85831683963E-06 2.93067542765E-06 3.00486577739E-06 3.08093425991E-06 3.15892842013E-06 3.23889700659E-06 3.32089000188E-06 3.40495865389E-06 3.49115550785E-06 3.57953443916E-06 3.67015068706E-06 3.76306088919E-06 3.85832311694E-06 3.95599691175E-06 4.05614332238E-06 4.15882494300E-06 4.26410595235E-06 4.37205215383E-06 4.48273101664E-06 4.59621171798E-06 4.71256518620E-06 4.83186414522E-06 4.95418315994E-06 5.07959868286E-06 5.20818910182E-06 5.34003478907E-06 5.47521815143E-06 5.61382368183E-06 5.75593801212E-06 5.90164996720E-06 6.05105062054E-06 6.20423335111E-06 6.36129390173E-06 6.52233043891E-06 6.68744361422E-06 6.85673662717E-06 7.03031528973E-06 7.20828809246E-06 7.39076627230E-06 7.57786388210E-06 7.76969786193E-06 7.96638811210E-06 8.16805756818E-06 8.37483227776E-06 8.58684147928E-06 8.80421768275E-06 9.02709675262E-06 9.25561799267E-06 9.48992423306E-06 9.73016191962E-06 9.97648120535E-06 1.02290360443E-05 1.04879842877E-05 1.07534877827E-05 1.10257124736E-05 1.13048285054E-05 1.15910103300E-05 1.18844368157E-05 1.21852913585E-05 1.24937619971E-05 1.28100415301E-05 1.31343276366E-05 1.34668229999E-05 1.38077354340E-05 1.41572780134E-05 1.45156692066E-05 1.48831330121E-05 1.52598990991E-05 1.56462029501E-05 1.60422860091E-05 1.64483958316E-05 1.68647862400E-05 1.72917174816E-05 1.77294563918E-05 1.81782765604E-05 1.86384585029E-05 1.91102898357E-05 1.95940654557E-05 2.00900877247E-05 2.05986666586E-05 2.11201201205E-05 2.16547740200E-05 2.22029625166E-05 2.27650282284E-05 2.33413224462E-05 2.39322053535E-05 2.45380462508E-05 2.51592237871E-05 2.57961261960E-05 2.64491515386E-05 2.71187079521E-05 2.78052139050E-05 2.85090984583E-05 2.92308015339E-05 2.99707741893E-05 3.07294788996E-05 3.15073898464E-05 3.23049932140E-05 3.31227874934E-05 3.39612837936E-05 3.48210061612E-05 3.57024919075E-05 3.66062919444E-05 3.75329711287E-05 3.84831086151E-05 3.94572982178E-05 4.04561487816E-05 4.14802845624E-05 4.25303456173E-05 4.36069882043E-05 4.47108851924E-05 4.58427264823E-05 4.70032194367E-05 4.81930893231E-05 4.94130797662E-05 5.06639532131E-05 5.19464914091E-05 5.32614958863E-05 5.46097884646E-05 5.59922117647E-05 5.74096297346E-05 5.88629281896E-05 6.03530153654E-05 6.18808224854E-05 6.34473043428E-05 6.50534398964E-05 6.67002328831E-05 6.83887124436E-05 7.01199337666E-05 7.18949787469E-05 7.37149566616E-05 7.55810048629E-05 7.74942894888E-05 7.94560061909E-05 8.14673808814E-05 8.35296704992E-05 8.56441637944E-05 8.78121821332E-05 9.00350803238E-05 9.23142474615E-05 9.46511077970E-05 9.70471216258E-05 9.95037861996E-05 1.02022636662E-04 1.04605247006E-04 1.07253231058E-04 1.09968243486E-04 1.12751980831E-04 1.15606182567E-04 1.18532632189E-04 1.21533158323E-04 1.24609635870E-04 1.27763987177E-04 1.30998183237E-04 1.34314244916E-04 1.37714244220E-04 1.41200305585E-04 1.44774607204E-04 1.48439382387E-04 1.52196920954E-04 1.56049570666E-04 1.59999738688E-04 1.64049893094E-04 1.68202564405E-04 1.72460347171E-04 1.76825901587E-04 1.81301955155E-04 1.85891304385E-04 1.90596816542E-04 1.95421431433E-04 2.00368163241E-04 2.05440102407E-04 2.10640417558E-04 2.15972357484E-04 2.21439253160E-04 2.27044519833E-04 2.32791659144E-04 2.38684261314E-04 2.44726007388E-04 2.50920671523E-04 2.57272123349E-04 2.63784330376E-04 2.70461360471E-04 2.77307384396E-04 2.84326678404E-04 2.91523626909E-04 2.98902725216E-04 3.06468582325E-04 3.14225923805E-04 3.22179594735E-04 3.30334562730E-04 3.38695921030E-04 3.47268891677E-04 3.56058828770E-04 3.65071221798E-04 3.74311699063E-04 3.83786031182E-04 3.93500134684E-04 4.03460075696E-04 4.13672073717E-04 4.24142505495E-04 4.34877908994E-04 4.45884987468E-04 4.57170613630E-04 4.68741833933E-04 4.80605872955E-04 4.92770137895E-04 5.05242223180E-04 5.18029915195E-04 5.31141197122E-04 5.44584253908E-04 5.58367477359E-04 5.72499471352E-04 5.86989057190E-04 6.01845279087E-04 6.17077409785E-04 6.32694956324E-04 6.48707665946E-04 6.65125532154E-04 6.81958800920E-04 6.99217977048E-04 7.16913830703E-04 7.35057404096E-04 7.53660018338E-04 7.72733280474E-04 7.92289090684E-04 8.12339649664E-04 8.32897466205E-04 8.53975364945E-04 8.75586494327E-04 8.97744334749E-04 9.20462706928E-04 9.43755780459E-04 9.67638082602E-04 9.92124507281E-04 1.01723032431E-03 1.04297118884E-03 1.06936315108E-03 1.09642266620E-03 1.12416660453E-03 1.15261226200E-03 1.18177737083E-03 1.21168011050E-03 1.24233911899E-03 1.27377350429E-03 1.30600285623E-03 1.33904725855E-03 1.37292730130E-03 1.40766409359E-03 1.44327927659E-03 1.47979503686E-03 1.51723412008E-03 1.55561984502E-03 1.59497611795E-03 1.63532744736E-03 1.67669895904E-03 1.71911641154E-03 1.76260621206E-03 1.80719543264E-03 1.85291182686E-03 1.89978384684E-03 1.94784066075E-03 1.99711217075E-03 2.04762903126E-03 2.09942266786E-03 2.15252529649E-03 2.20696994322E-03 2.26279046450E-03 2.32002156786E-03 2.37869883314E-03 2.43885873430E-03 2.50053866166E-03 2.56377694479E-03 2.62861287586E-03 2.69508673367E-03 2.76323980816E-03 2.83311442562E-03 2.90475397444E-03 2.97820293151E-03 3.05350688930E-03 3.13071258354E-03 3.20986792163E-03 3.29102201168E-03 3.37422519232E-03 3.45952906321E-03 3.54698651622E-03 3.63665176750E-03 3.72858039021E-03 3.82282934810E-03 3.91945702986E-03 4.01852328434E-03 4.12008945656E-03 4.22421842469E-03 4.33097463775E-03 4.44042415438E-03 4.55263468245E-03 4.66767561962E-03 4.78561809486E-03 4.90653501102E-03 5.03050108834E-03 5.15759290901E-03 5.28788896281E-03 5.42146969379E-03 5.55841754810E-03 5.69881702287E-03 5.84275471634E-03 5.99031937906E-03 6.14160196637E-03 6.29669569204E-03 6.45569608320E-03 6.61870103657E-03 6.78581087587E-03 6.95712841073E-03 7.13275899682E-03 7.31281059745E-03 7.49739384648E-03 7.68662211281E-03 7.88061156619E-03 8.07948124466E-03 8.28335312341E-03 8.49235218523E-03 8.70660649262E-03 8.92624726135E-03 9.15140893585E-03 9.38222926614E-03 9.61884938655E-03 9.86141389609E-03 1.01100709407E-02 1.03649722972E-02 1.06262734593E-02 1.08941337247E-02 1.11687162856E-02 1.14501883193E-02 1.17387210823E-02 1.20344900054E-02 1.23376747912E-02 1.26484595140E-02 1.29670327207E-02 1.32935875353E-02 1.36283217641E-02 1.39714380040E-02 1.43231437530E-02 1.46836515221E-02 1.50531789504E-02 1.54319489221E-02 1.58201896856E-02 1.62181349753E-02 1.66260241357E-02 1.70441022476E-02 1.74726202570E-02 1.79118351065E-02 1.83620098686E-02 1.88234138824E-02 1.92963228918E-02 1.97810191868E-02 2.02777917472E-02 2.07869363889E-02 2.13087559122E-02 2.18435602535E-02 2.23916666389E-02 2.29533997406E-02 2.35290918355E-02 2.41190829670E-02 2.47237211088E-02 2.53433623309E-02 2.59783709693E-02 2.66291197965E-02 2.72959901960E-02 2.79793723382E-02 2.86796653589E-02 2.93972775404E-02 3.01326264946E-02 3.08861393482E-02 3.16582529305E-02 3.24494139629E-02 3.32600792504E-02 3.40907158754E-02 3.49418013928E-02 3.58138240269E-02 3.67072828706E-02 3.76226880850E-02 3.85605611012E-02 3.95214348227E-02 4.05058538292E-02 4.15143745810E-02 4.25475656246E-02 4.36060077977E-02 4.46902944357E-02 4.58010315772E-02 4.69388381698E-02 4.81043462753E-02 4.92982012743E-02 5.05210620689E-02 5.17736012849E-02 5.30565054720E-02 5.43704753013E-02 5.57162257608E-02 5.70944863481E-02 5.85060012589E-02 5.99515295720E-02 6.14318454305E-02 6.29477382168E-02 6.45000127232E-02 6.60894893158E-02 6.77170040918E-02 6.93834090292E-02 7.10895721286E-02 7.28363775460E-02 7.46247257157E-02 7.64555334628E-02 7.83297341044E-02 8.02482775382E-02 8.22121303178E-02 8.42222757133E-02 8.62797137574E-02 8.83854612736E-02 9.05405518872E-02 9.27460360172E-02 9.50029808477E-02 9.73124702773E-02 9.96756048452E-02 1.02093501633E-01 1.04567294138E-01 1.07098132124E-01 1.09687181433E-01 1.12335623774E-01 1.15044656474E-01 1.17815492191E-01 1.20649358597E-01 1.23547498014E-01 1.26511167008E-01 1.29541635946E-01 1.32640188494E-01 1.35808121079E-01 1.39046742287E-01 1.42357372212E-01 1.45741341750E-01 1.49199991823E-01 1.52734672552E-01 1.56346742349E-01 1.60037566952E-01 1.63808518378E-01 1.67660973801E-01 1.71596314355E-01 1.75615923842E-01 1.79721187366E-01 1.83913489862E-01 1.88194214542E-01 1.92564741229E-01 1.97026444602E-01 2.01580692321E-01 2.06228843045E-01 2.10972244339E-01 2.15812230454E-01 2.20750119984E-01 2.25787213401E-01 2.30924790450E-01 2.36164107412E-01 2.41506394222E-01 2.46952851445E-01 2.52504647108E-01 2.58162913366E-01 2.63928743028E-01 2.69803185912E-01 2.75787245039E-01 2.81881872668E-01 2.88087966155E-01 2.94406363644E-01 3.00837839585E-01 3.07383100083E-01 3.14042778063E-01 3.20817428269E-01 3.27707522084E-01 3.34713442172E-01 3.41835476963E-01 3.49073814950E-01 3.56428538834E-01 3.63899619504E-01 3.71486909864E-01 3.79190138508E-01 3.87008903261E-01 3.94942664586E-01 4.02990738877E-01 4.11152291645E-01 4.19426330612E-01 4.27811698733E-01 4.36307067163E-01 4.44910928188E-01 4.53621588146E-01 4.62437160360E-01 4.71355558113E-01 4.80374487692E-01 4.89491441542E-01 4.98703691550E-01 5.08008282516E-01 5.17402025839E-01 5.26881493459E-01 5.36443012127E-01 5.46082658011E-01 5.55796251738E-01 5.65579353883E-01 5.75427261004E-01 5.85335002252E-01 5.95297336641E-01 6.05308751030E-01 6.15363458902E-01 6.25455399991E-01 6.35578240848E-01 6.45725376401E-01 6.55889932602E-01 6.66064770221E-01 6.76242489866E-01 6.86415438304E-01 6.96575716153E-01 7.06715187009E-01 7.16825488089E-01 7.26898042425E-01 7.36924072699E-01 7.46894616733E-01 7.56800544705E-01 7.66632578109E-01 7.76381310485E-01 7.86037229938E-01 7.95590743426E-01 8.05032202833E-01 8.14351932764E-01 8.23540260039E-01 8.32587544807E-01 8.41484213201E-01 8.50220791426E-01 8.58787941151E-01 8.67176496065E-01 8.75377499400E-01 8.83382242249E-01 8.91182302437E-01 8.98769583700E-01 9.06136354904E-01 9.13275288995E-01 9.20179501362E-01 9.26842587268E-01 9.33258657979E-01 9.39422375190E-01 9.45328983363E-01 9.50974339531E-01 9.56354940150E-01 9.61467944534E-01 9.66311194445E-01 9.70883229361E-01 9.75183296995E-01 9.79211358600E-01 9.82968088656E-01 9.86454868511E-01 9.89673773609E-01 9.92627553944E-01 9.95319607445E-01 9.97753946016E-01 9.99935154042E-01 1.00186833922E+00 1.00355907563E+00 1.00501333917E+00 1.00623743527E+00 1.00723791945E+00 1.00802151070E+00 1.00859499856E+00 1.00896514434E+00 1.00913857737E+00 1.00912168743E+00 1.00892051456E+00 1.00854063777E+00 1.00798706448E+00 1.00726412276E+00 1.00637535882E+00 1.00532344228E+00 1.00411008251E+00 1.00273595920E+00 1.00120067089E+00 9.99502705251E-01 9.97639435248E-01 9.95607145130E-01 9.93401090165E-01 9.91015593596E-01 9.88444183560E-01 9.85679771547E-01 9.82714872317E-01 9.79541862803E-01 9.76153274370E-01 9.72542108660E-01 9.68702161844E-01 9.64628335419E-01 9.60316903182E-01 9.55765693667E-01 9.50974134540E-01 9.45943089987E-01 9.40674420249E-01 9.35170391613E-01 9.29433489199E-01 9.23466402910E-01 9.17272026524E-01 9.10853456598E-01 9.04213991165E-01 8.97357128236E-01 8.90286564063E-01 8.83006191188E-01 8.75520096236E-01 8.67832557440E-01 8.59948041901E-01 8.51871202527E-01 8.43606874667E-01 8.35160072386E-01 8.26535984386E-01 8.17739969518E-01 8.08777551895E-01 7.99654415547E-01 7.90376398626E-01 7.80949487117E-01 7.71379808054E-01 7.61673622211E-01 7.51837316268E-01 7.41877394446E-01 7.31800469607E-01 7.21613253825E-01 7.11322548461E-01 7.00935233738E-01 6.90458257876E-01 6.79898625813E-01 6.69263387564E-01 6.58559626286E-01 6.47794446108E-01 6.36974959799E-01 6.26108276376E-01 6.15201488706E-01 6.04261661222E-01 5.93295817827E-01 5.82310930091E-01 5.71313905822E-01 5.60311578106E-01 5.49310694896E-01 5.38317909228E-01 5.27339770131E-01 5.16382714288E-01 5.05453058494E-01 4.94556992960E-01 4.83700575456E-01 4.72889726344E-01 4.62130224457E-01 4.51427703839E-01 4.40787651300E-01 4.30215404754E-01 4.19716152277E-01 4.09294931833E-01 3.98956631597E-01 3.88705990779E-01 3.78547600883E-01 3.68485907295E-01 3.58525211114E-01 3.48669671127E-01 3.38923305834E-01 3.29289995426E-01 3.19773483642E-01 3.10377379402E-01 3.01105158162E-01 2.91960162908E-01 2.82945604749E-01 2.74064563064E-01 2.65319985161E-01 2.56714685451E-01 2.48251344126E-01 2.39932505340E-01 2.31760574947E-01 2.23737817798E-01 2.15866354682E-01 2.08148158935E-01 2.00585052813E-01 1.93178703685E-01 1.85930620142E-01 1.78842148084E-01 1.71914466899E-01 1.65148585781E-01 1.58545340310E-01 1.52105389335E-01 1.45829212254E-01 1.39717106753E-01 1.33769187061E-01 1.27985382765E-01 1.22365438241E-01 1.16908912714E-01 1.11615180995E-01 1.06483434876E-01 1.01512685227E-01 9.67017647530E-02 9.20493314356E-02 8.75538726116E-02 8.32137096854E-02 7.90270034328E-02 7.49917598672E-02 7.11058366253E-02 6.73669498320E-02 6.37726813971E-02 6.03204866979E-02 5.70077025970E-02 5.38315557467E-02 5.07891711297E-02 4.78775807855E-02 4.50937326741E-02 4.24344996288E-02 3.98966883510E-02 3.74770484017E-02 3.51722811472E-02 3.29790486181E-02 3.08939822418E-02 2.89136914134E-02 2.70347718712E-02 2.52538138449E-02 2.35674099491E-02 2.19721627957E-02 2.04646923029E-02 1.90416426793E-02 1.76996890673E-02 1.64355438287E-02 1.52459624614E-02 1.41277491371E-02 1.30777618516E-02 1.20929171829E-02 1.11701946550E-02 1.03066407043E-02 9.49937225174E-03 8.74557988321E-03 8.04253064197E-03 7.38757044105E-03 6.77812610282E-03 6.21170703539E-03 5.68590655685E-03 5.19840287900E-03 4.74695976404E-03 4.32942686786E-03 3.94373978503E-03 3.58791981087E-03 3.26007343679E-03 2.95839159540E-03 2.68114867240E-03 2.42670130237E-03 2.19348696578E-03 1.98002240451E-03 1.78490187322E-03 1.60679524359E-03 1.44444597843E-03 1.29666899197E-03 1.16234841273E-03 1.04043526439E-03 9.29945079897E-04 8.29955463285E-04 7.39603613082E-04 6.58083820440E-04 5.84644954427E-04 5.18587946127E-04 4.59263282368E-04 4.06069630096E-04 3.58460172624E-04 3.15918647556E-04 2.77967821012E-04 2.44168444636E-04 2.14116942045E-04 1.87443170117E-04 1.63808258587E-04 1.42902530812E-04 1.24443507978E-04 1.08173998429E-04 9.38602732689E-05 8.12903288383E-05 7.02722362000E-05 6.06325772799E-05 5.22149668985E-05 4.48786595230E-05 3.84972392156E-05 3.29573909262E-05 2.81577509921E-05 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 3P 1 3.42753715284E-07 3.49966522970E-07 3.57331114846E-07 3.64850685011E-07 3.72540466244E-07 3.80429441979E-07 3.88515545195E-07 3.96804563989E-07 4.05301126472E-07 4.14009999194E-07 4.22936060408E-07 4.32084309362E-07 4.41459956497E-07 4.51068304694E-07 4.60914558290E-07 4.71004177895E-07 4.81342930681E-07 4.91936618402E-07 5.02791212583E-07 5.13912857196E-07 5.25307837709E-07 5.36982587119E-07 5.48943703539E-07 5.61197958137E-07 5.73752280620E-07 5.86613778088E-07 5.99789755166E-07 6.13287688374E-07 6.27115224429E-07 6.41280212277E-07 6.55790712675E-07 6.70654979179E-07 6.85881461757E-07 7.01478829194E-07 7.17455964066E-07 7.33821971375E-07 7.50586183438E-07 7.67758165564E-07 7.85347721732E-07 8.03364901214E-07 8.21820007171E-07 8.40723598393E-07 8.60086488841E-07 8.79919769116E-07 9.00234810929E-07 9.21043259358E-07 9.42357051505E-07 9.64188423363E-07 9.86549916254E-07 1.00945439254E-06 1.03291502779E-06 1.05694532271E-06 1.08155912720E-06 1.10677063063E-06 1.13259437173E-06 1.15904525539E-06 1.18613855682E-06 1.21388993239E-06 1.24231542881E-06 1.27143149297E-06 1.30125498189E-06 1.33180317296E-06 1.36309377443E-06 1.39514493621E-06 1.42797526086E-06 1.46160381491E-06 1.49605014050E-06 1.53133426719E-06 1.56747672424E-06 1.60449855301E-06 1.64242131985E-06 1.68126712917E-06 1.72105863691E-06 1.76181906442E-06 1.80357221266E-06 1.84634247645E-06 1.89015485906E-06 1.93503498811E-06 1.98100913092E-06 2.02810421029E-06 2.07634782160E-06 2.12576824963E-06 2.17639448513E-06 2.22825624282E-06 2.28138397947E-06 2.33580891217E-06 2.39156303795E-06 2.44867915301E-06 2.50719087284E-06 2.56713265273E-06 2.62853980881E-06 2.69144853965E-06 2.75589594834E-06 2.82192006518E-06 2.88955987093E-06 2.95885532060E-06 3.02984736793E-06 3.10257799036E-06 3.17709021473E-06 3.25342814360E-06 3.33163698219E-06 3.41176306603E-06 3.49385388935E-06 3.57795813405E-06 3.66412569953E-06 3.75240773324E-06 3.84285666192E-06 3.93552622372E-06 4.03047150105E-06 4.12774895435E-06 4.22741645658E-06 4.32953332867E-06 4.43416037585E-06 4.54135992484E-06 4.65119586203E-06 4.76373367257E-06 4.87904048050E-06 4.99718508980E-06 5.11823802658E-06 5.24227158219E-06 5.36935985757E-06 5.49957880856E-06 5.63300629247E-06 5.76972211572E-06 5.90980808274E-06 6.05334804607E-06 6.20042795769E-06 6.35113592171E-06 6.50556224828E-06 6.66379950904E-06 6.82594259321E-06 6.99208876298E-06 7.16233771545E-06 7.33679165208E-06 7.51555533827E-06 7.69873616346E-06 7.88644419604E-06 8.07879225467E-06 8.27589599374E-06 8.47787396491E-06 8.68484768695E-06 8.89694172339E-06 9.11428375760E-06 9.33700467119E-06 9.56523862413E-06 9.79912313691E-06 1.00387991748E-05 1.02844112339E-05 1.05361074301E-05 1.07940395893E-05 1.10583633406E-05 1.13292382113E-05 1.16068277251E-05 1.18912995015E-05 1.21828253589E-05 1.24815814194E-05 1.27877482170E-05 1.31015108076E-05 1.34230588825E-05 1.37525868845E-05 1.40902941264E-05 1.44363849137E-05 1.47910686688E-05 1.51545600593E-05 1.55270791298E-05 1.59088514355E-05 1.63001081809E-05 1.67010863607E-05 1.71120289048E-05 1.75331848268E-05 1.79648093760E-05 1.84071641937E-05 1.88605174726E-05 1.93251441210E-05 1.98013259305E-05 2.02893517481E-05 2.07895176527E-05 2.13021271356E-05 2.18274912862E-05 2.23659289814E-05 2.29177670802E-05 2.34833406237E-05 2.40629930387E-05 2.46570763477E-05 2.52659513835E-05 2.58899880089E-05 2.65295653424E-05 2.71850719895E-05 2.78569062788E-05 2.85454765056E-05 2.92512011798E-05 2.99745092813E-05 3.07158405207E-05 3.14756456078E-05 3.22543865249E-05 3.30525368087E-05 3.38705818381E-05 3.47090191292E-05 3.55683586383E-05 3.64491230715E-05 3.73518482028E-05 3.82770831991E-05 3.92253909545E-05 4.01973484317E-05 4.11935470125E-05 4.22145928567E-05 4.32611072700E-05 4.43337270812E-05 4.54331050280E-05 4.65599101533E-05 4.77148282102E-05 4.88985620782E-05 5.01118321886E-05 5.13553769613E-05 5.26299532512E-05 5.39363368070E-05 5.52753227404E-05 5.66477260069E-05 5.80543818988E-05 5.94961465501E-05 6.09738974541E-05 6.24885339930E-05 6.40409779817E-05 6.56321742236E-05 6.72630910815E-05 6.89347210612E-05 7.06480814102E-05 7.24042147312E-05 7.42041896100E-05 7.60491012592E-05 7.79400721779E-05 7.98782528271E-05 8.18648223220E-05 8.39009891411E-05 8.59879918525E-05 8.81270998585E-05 9.03196141576E-05 9.25668681260E-05 9.48702283177E-05 9.72310952840E-05 9.96509044133E-05 1.02131126792E-04 1.04673270083E-04 1.07278879435E-04 1.09949538397E-04 1.12686869876E-04 1.15492537100E-04 1.18368244614E-04 1.21315739301E-04 1.24336811419E-04 1.27433295675E-04 1.30607072314E-04 1.33860068244E-04 1.37194258182E-04 1.40611665827E-04 1.44114365068E-04 1.47704481217E-04 1.51384192270E-04 1.55155730200E-04 1.59021382286E-04 1.62983492465E-04 1.67044462727E-04 1.71206754533E-04 1.75472890277E-04 1.79845454773E-04 1.84327096792E-04 1.88920530619E-04 1.93628537662E-04 1.98453968089E-04 2.03399742514E-04 2.08468853714E-04 2.13664368394E-04 2.18989428990E-04 2.24447255520E-04 2.30041147476E-04 2.35774485756E-04 2.41650734657E-04 2.47673443899E-04 2.53846250710E-04 2.60172881948E-04 2.66657156292E-04 2.73302986465E-04 2.80114381520E-04 2.87095449186E-04 2.94250398255E-04 3.01583541038E-04 3.09099295876E-04 3.16802189704E-04 3.24696860687E-04 3.32788060910E-04 3.41080659133E-04 3.49579643613E-04 3.58290124991E-04 3.67217339247E-04 3.76366650728E-04 3.85743555239E-04 3.95353683217E-04 4.05202802970E-04 4.15296824000E-04 4.25641800395E-04 4.36243934310E-04 4.47109579524E-04 4.58245245076E-04 4.69657598995E-04 4.81353472113E-04 4.93339861961E-04 5.05623936763E-04 5.18213039521E-04 5.31114692192E-04 5.44336599965E-04 5.57886655634E-04 5.71772944072E-04 5.86003746813E-04 6.00587546733E-04 6.15533032843E-04 6.30849105188E-04 6.46544879864E-04 6.62629694148E-04 6.79113111740E-04 6.96004928132E-04 7.13315176096E-04 7.31054131295E-04 7.49232318031E-04 7.67860515107E-04 7.86949761840E-04 8.06511364195E-04 8.26556901072E-04 8.47098230716E-04 8.68147497295E-04 8.89717137604E-04 9.11819887934E-04 9.34468791087E-04 9.57677203553E-04 9.81458802846E-04 1.00582759500E-03 1.03079792224E-03 1.05638447080E-03 1.08260227897E-03 1.10946674524E-03 1.13699363669E-03 1.16519909755E-03 1.19409965793E-03 1.22371224273E-03 1.25405418082E-03 1.28514321432E-03 1.31699750814E-03 1.34963565976E-03 1.38307670910E-03 1.41734014877E-03 1.45244593440E-03 1.48841449526E-03 1.52526674513E-03 1.56302409331E-03 1.60170845597E-03 1.64134226771E-03 1.68194849331E-03 1.72355063979E-03 1.76617276875E-03 1.80983950887E-03 1.85457606876E-03 1.90040825009E-03 1.94736246089E-03 1.99546572925E-03 2.04474571723E-03 2.09523073509E-03 2.14694975579E-03 2.19993242984E-03 2.25420910039E-03 2.30981081865E-03 2.36676935968E-03 2.42511723841E-03 2.48488772607E-03 2.54611486688E-03 2.60883349514E-03 2.67307925261E-03 2.73888860628E-03 2.80629886646E-03 2.87534820528E-03 2.94607567545E-03 3.01852122952E-03 3.09272573947E-03 3.16873101658E-03 3.24657983189E-03 3.32631593687E-03 3.40798408456E-03 3.49163005116E-03 3.57730065796E-03 3.66504379371E-03 3.75490843742E-03 3.84694468161E-03 3.94120375594E-03 4.03773805134E-03 4.13660114452E-03 4.23784782302E-03 4.34153411063E-03 4.44771729333E-03 4.55645594565E-03 4.66780995759E-03 4.78184056192E-03 4.89861036203E-03 5.01818336024E-03 5.14062498664E-03 5.26600212838E-03 5.39438315953E-03 5.52583797138E-03 5.66043800336E-03 5.79825627435E-03 5.93936741461E-03 6.08384769822E-03 6.23177507606E-03 6.38322920930E-03 6.53829150345E-03 6.69704514299E-03 6.85957512649E-03 7.02596830233E-03 7.19631340498E-03 7.37070109179E-03 7.54922398041E-03 7.73197668672E-03 7.91905586338E-03 8.11056023889E-03 8.30659065729E-03 8.50725011835E-03 8.71264381844E-03 8.92287919186E-03 9.13806595282E-03 9.35831613798E-03 9.58374414956E-03 9.81446679899E-03 1.00506033512E-02 1.02922755694E-02 1.05396077604E-02 1.07927268208E-02 1.10517622832E-02 1.13168463634E-02 1.15881140080E-02 1.18657029426E-02 1.21497537205E-02 1.24404097716E-02 1.27378174527E-02 1.30421260972E-02 1.33534880664E-02 1.36720588004E-02 1.39979968699E-02 1.43314640285E-02 1.46726252653E-02 1.50216488583E-02 1.53787064276E-02 1.57439729895E-02 1.61176270110E-02 1.64998504645E-02 1.68908288830E-02 1.72907514154E-02 1.76998108826E-02 1.81182038332E-02 1.85461306003E-02 1.89837953579E-02 1.94314061780E-02 1.98891750873E-02 2.03573181249E-02 2.08360553994E-02 2.13256111463E-02 2.18262137859E-02 2.23380959809E-02 2.28614946935E-02 2.33966512437E-02 2.39438113665E-02 2.45032252690E-02 2.50751476883E-02 2.56598379479E-02 2.62575600149E-02 2.68685825563E-02 2.74931789952E-02 2.81316275663E-02 2.87842113716E-02 2.94512184346E-02 3.01329417548E-02 3.08296793612E-02 3.15417343649E-02 3.22694150111E-02 3.30130347305E-02 3.37729121892E-02 3.45493713382E-02 3.53427414615E-02 3.61533572229E-02 3.69815587120E-02 3.78276914886E-02 3.86921066255E-02 3.95751607501E-02 4.04772160846E-02 4.13986404834E-02 4.23398074704E-02 4.33010962729E-02 4.42828918541E-02 4.52855849436E-02 4.63095720652E-02 4.73552555629E-02 4.84230436238E-02 4.95133502990E-02 5.06265955212E-02 5.17632051198E-02 5.29236108328E-02 5.41082503158E-02 5.53175671471E-02 5.65520108304E-02 5.78120367926E-02 5.90981063791E-02 6.04106868444E-02 6.17502513385E-02 6.31172788901E-02 6.45122543841E-02 6.59356685355E-02 6.73880178578E-02 6.88698046270E-02 7.03815368402E-02 7.19237281689E-02 7.34968979067E-02 7.51015709116E-02 7.67382775418E-02 7.84075535858E-02 8.01099401861E-02 8.18459837562E-02 8.36162358908E-02 8.54212532690E-02 8.72615975506E-02 8.91378352639E-02 9.10505376874E-02 9.30002807219E-02 9.49876447554E-02 9.70132145194E-02 9.90775789359E-02 1.01181330957E-01 1.03325067392E-01 1.05509388729E-01 1.07734898947E-01 1.10002205310E-01 1.12311918162E-01 1.14664650704E-01 1.17061018764E-01 1.19501640553E-01 1.21987136410E-01 1.24518128538E-01 1.27095240725E-01 1.29719098057E-01 1.32390326611E-01 1.35109553143E-01 1.37877404759E-01 1.40694508572E-01 1.43561491351E-01 1.46478979147E-01 1.49447596910E-01 1.52467968095E-01 1.55540714247E-01 1.58666454573E-01 1.61845805501E-01 1.65079380221E-01 1.68367788210E-01 1.71711634744E-01 1.75111520389E-01 1.78568040484E-01 1.82081784596E-01 1.85653335964E-01 1.89283270932E-01 1.92972158352E-01 1.96720558979E-01 2.00529024846E-01 2.04398098620E-01 2.08328312942E-01 2.12320189747E-01 2.16374239569E-01 2.20490960823E-01 2.24670839078E-01 2.28914346298E-01 2.33221940078E-01 2.37594062855E-01 2.42031141103E-01 2.46533584508E-01 2.51101785127E-01 2.55736116527E-01 2.60436932911E-01 2.65204568220E-01 2.70039335222E-01 2.74941524580E-01 2.79911403912E-01 2.84949216817E-01 2.90055181907E-01 2.95229491802E-01 3.00472312122E-01 3.05783780458E-01 3.11164005333E-01 3.16613065139E-01 3.22131007068E-01 3.27717846023E-01 3.33373563522E-01 3.39098106580E-01 3.44891386581E-01 3.50753278142E-01 3.56683617957E-01 3.62682203629E-01 3.68748792497E-01 3.74883100442E-01 3.81084800686E-01 3.87353522577E-01 3.93688850361E-01 4.00090321944E-01 4.06557427640E-01 4.13089608907E-01 4.19686257068E-01 4.26346712018E-01 4.33070260923E-01 4.39856136897E-01 4.46703517667E-01 4.53611524221E-01 4.60579219441E-01 4.67605606722E-01 4.74689628563E-01 4.81830165153E-01 4.89026032928E-01 4.96275983119E-01 5.03578700272E-01 5.10932800759E-01 5.18336831270E-01 5.25789267285E-01 5.33288511540E-01 5.40832892481E-01 5.48420662710E-01 5.56049997430E-01 5.63718992902E-01 5.71425664905E-01 5.79167947224E-01 5.86943690176E-01 5.94750659177E-01 6.02586533383E-01 6.10448904408E-01 6.18335275163E-01 6.26243058834E-01 6.34169578034E-01 6.42112064178E-01 6.50067657137E-01 6.58033405211E-01 6.66006265524E-01 6.73983104898E-01 6.81960701323E-01 6.89935746123E-01 6.97904846952E-01 7.05864531749E-01 7.13811253799E-01 7.21741398040E-01 7.29651288725E-01 7.37537198553E-01 7.45395359270E-01 7.53221973685E-01 7.61013228888E-01 7.68765310284E-01 7.76474415810E-01 7.84136769459E-01 7.91748632913E-01 7.99306313832E-01 8.06806169120E-01 8.14244601415E-01 8.21618047136E-01 8.28922954795E-01 8.36155752934E-01 8.43312807933E-01 8.50390373104E-01 8.57384531641E-01 8.64291137112E-01 8.71105755966E-01 8.77823616901E-01 8.84439571653E-01 8.90948070982E-01 8.97343158154E-01 9.03618480486E-01 9.09767317534E-01 9.15782622806E-01 9.21657074576E-01 9.27383130821E-01 9.32953083481E-01 9.38359108059E-01 9.43593305834E-01 9.48647737296E-01 9.53514446667E-01 9.58185478291E-01 9.62652886239E-01 9.66908738757E-01 9.70945119112E-01 9.74754124264E-01 9.78327862491E-01 9.81658450848E-01 9.84738013069E-01 9.87558678297E-01 9.90112580890E-01 9.92391861392E-01 9.94388668687E-01 9.96095163295E-01 9.97503521706E-01 9.98605941671E-01 9.99394648293E-01 9.99861900820E-01 1.00000000000E+00 9.99801295876E-01 9.99258195919E-01 9.98363173389E-01 9.97108775835E-01 9.95487633659E-01 9.93492468674E-01 9.91116102603E-01 9.88351465479E-01 9.85191603902E-01 9.81629689149E-01 9.77659025094E-01 9.73273055951E-01 9.68465373824E-01 9.63229726069E-01 9.57560022472E-01 9.51450342236E-01 9.44894940817E-01 9.37888256576E-01 9.30424917295E-01 9.22499746546E-01 9.14107769925E-01 9.05244221172E-01 8.95904548171E-01 8.86084418860E-01 8.75779727028E-01 8.64986598044E-01 8.53701394492E-01 8.41920721736E-01 8.29641433415E-01 8.16860636867E-01 8.03575698491E-01 7.89784249050E-01 7.75484188895E-01 7.60673693145E-01 7.45351216783E-01 7.29515499686E-01 7.13165571580E-01 6.96300756904E-01 6.78920679591E-01 6.61025267731E-01 6.42614758131E-01 6.23689700734E-01 6.04250962900E-01 5.84299733519E-01 5.63837526945E-01 5.42866186726E-01 5.21387889110E-01 4.99405146313E-01 4.76920809510E-01 4.53938071552E-01 4.30460469361E-01 4.06491886009E-01 3.82036552443E-01 3.57099048868E-01 3.31684305746E-01 3.05797604446E-01 2.79444577517E-01 2.52631208615E-01 2.25363832091E-01 1.97649132284E-01 1.69494142550E-01 1.40906244075E-01 1.11893164556E-01 8.24629768034E-02 5.26240973681E-02 2.23852852908E-02 -8.24435892071E-03 -3.92553939619E-02 -7.06380379253E-02 -1.02382167886E-01 -1.34477318750E-01 -1.66912681224E-01 -1.99677098801E-01 -2.32759063623E-01 -2.66146711134E-01 -2.99827813438E-01 -3.33789771291E-01 -3.68019604698E-01 -4.02503942102E-01 -4.37229008201E-01 -4.72180610437E-01 -5.07344124283E-01 -5.42704477433E-01 -5.78246133106E-01 -6.13953072668E-01 -6.49808777826E-01 -6.85796212706E-01 -7.21897806138E-01 -7.58095434510E-01 -7.94370405588E-01 -8.30703443714E-01 -8.67074676816E-01 -9.03463625659E-01 -9.39849195799E-01 -9.76209672662E-01 -1.01252272018E+00 -1.04876538339E+00 -1.08491409534E+00 -1.12094468870E+00 -1.15683241229E+00 -1.19255195274E+00 -1.22807746157E+00 -1.26338258761E+00 -1.29844051491E+00 -1.33322400602E+00 -1.36770545049E+00 -1.40185691835E+00 -1.43565021838E+00 -1.46905696059E+00 -1.50204862264E+00 -1.53459661958E+00 -1.56667237639E+00 -1.59824740261E+00 -1.62929336865E+00 -1.65978218278E+00 -1.68968606839E+00 -1.71897764081E+00 -1.74762998292E+00 -1.77561671903E+00 -1.80291208648E+00 -1.82949100431E+00 -1.85532913866E+00 -1.88040296434E+00 -1.90468982234E+00 -1.92816797293E+00 -1.95081664413E+00 -1.97261607539E+00 -1.99354755645E+00 -2.01359346121E+00 -2.03273727681E+00 -2.05096362779E+00 -2.06825829563E+00 -2.08460823370E+00 -2.10000157780E+00 -2.11442765265E+00 -2.12787697430E+00 -2.14034124899E+00 -2.15181336855E+00 -2.16228740254E+00 -2.17175858765E+00 -2.18022331437E+00 -2.18767911132E+00 -2.19412462743E+00 -2.19955961232E+00 -2.20398489497E+00 -2.20740236105E+00 -2.20981492897E+00 -2.21122652496E+00 -2.21164205740E+00 -2.21106739034E+00 -2.20950931672E+00 -2.20697553103E+00 -2.20347460194E+00 -2.19901594469E+00 -2.19360979353E+00 -2.18726717423E+00 -2.17999987677E+00 -2.17182042828E+00 -2.16274206622E+00 -2.15277871197E+00 -2.14194494480E+00 -2.13025597618E+00 -2.11772762466E+00 -2.10437629112E+00 -2.09021893448E+00 -2.07527304797E+00 -2.05955663581E+00 -2.04308819035E+00 -2.02588666966E+00 -2.00797147562E+00 -1.98936243236E+00 -1.97007976506E+00 -1.95014407919E+00 -1.92957634002E+00 -1.90839785245E+00 -1.88663024104E+00 -1.86429543030E+00 -1.84141562519E+00 -1.81801329161E+00 -1.79411113713E+00 -1.76973209166E+00 -1.74489928814E+00 -1.71963604320E+00 -1.69396583769E+00 -1.66791229709E+00 -1.64149917173E+00 -1.61475031678E+00 -1.58768967201E+00 -1.56034124120E+00 -1.53272907125E+00 -1.50487723089E+00 -1.47680978907E+00 -1.44855079284E+00 -1.42012424483E+00 -1.39155408035E+00 -1.36286414386E+00 -1.33407816518E+00 -1.30521973503E+00 -1.27631228025E+00 -1.24737903859E+00 -1.21844867746E+00 -1.18956740549E+00 -1.16077452483E+00 -1.13207692403E+00 -1.10349863089E+00 -1.07505815793E+00 -1.04677464106E+00 -1.01866693915E+00 -9.90753665824E-01 -9.63053156203E-01 -9.35583432177E-01 -9.08362168321E-01 -8.81406658329E-01 -8.54733782076E-01 -8.28359973444E-01 -8.02301188997E-01 -7.76572877626E-01 -7.51189951273E-01 -7.26166756832E-01 -7.01517049334E-01 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1.50 1.50 8.77946146892E-08 9.00173848465E-08 9.22964217259E-08 9.46331497630E-08 9.70290294524E-08 9.94855582613E-08 1.02004271565E-07 1.04586743605E-07 1.07234588478E-07 1.09949461137E-07 1.12733058433E-07 1.15587120172E-07 1.18513430202E-07 1.21513817529E-07 1.24590157461E-07 1.27744372778E-07 1.30978434937E-07 1.34294365300E-07 1.37694236401E-07 1.41180173240E-07 1.44754354611E-07 1.48419014463E-07 1.52176443298E-07 1.56028989604E-07 1.59979061318E-07 1.64029127334E-07 1.68181719048E-07 1.72439431937E-07 1.76804927183E-07 1.81280933334E-07 1.85870248013E-07 1.90575739664E-07 1.95400349347E-07 2.00347092572E-07 2.05419061191E-07 2.10619425321E-07 2.15951435335E-07 2.21418423887E-07 2.27023807998E-07 2.32771091190E-07 2.38663865677E-07 2.44705814612E-07 2.50900714383E-07 2.57252436982E-07 2.63764952418E-07 2.70442331200E-07 2.77288746885E-07 2.84308478681E-07 2.91505914125E-07 2.98885551827E-07 3.06452004276E-07 3.14210000728E-07 3.22164390162E-07 3.30320144305E-07 3.38682360748E-07 3.47256266124E-07 3.56047219381E-07 3.65060715128E-07 3.74302387071E-07 3.83778011533E-07 3.93493511064E-07 4.03454958146E-07 4.13668578984E-07 4.24140757400E-07 4.34878038825E-07 4.45887134385E-07 4.57174925101E-07 4.68748466186E-07 4.80614991456E-07 4.92781917852E-07 5.05256850076E-07 5.18047585342E-07 5.31162118251E-07 5.44608645789E-07 5.58395572450E-07 5.72531515484E-07 5.87025310292E-07 6.01886015941E-07 6.17122920830E-07 6.32745548493E-07 6.48763663554E-07 6.65187277829E-07 6.82026656582E-07 6.99292324946E-07 7.16995074494E-07 7.35145969992E-07 7.53756356309E-07 7.72837865512E-07 7.92402424131E-07 8.12462260619E-07 8.33029912994E-07 8.54118236671E-07 8.75740412505E-07 8.97909955020E-07 9.20640720864E-07 9.43946917467E-07 9.67843111918E-07 9.92344240074E-07 1.01746561590E-06 1.04322294101E-06 1.06963231455E-06 1.09671024317E-06 1.12447365141E-06 1.15293989225E-06 1.18212675797E-06 1.21205249125E-06 1.24273579659E-06 1.27419585199E-06 1.30645232095E-06 1.33952536474E-06 1.37343565502E-06 1.40820438676E-06 1.44385329147E-06 1.48040465080E-06 1.51788131045E-06 1.55630669447E-06 1.59570481989E-06 1.63610031172E-06 1.67751841837E-06 1.71998502740E-06 1.76352668171E-06 1.80817059614E-06 1.85394467448E-06 1.90087752689E-06 1.94899848780E-06 1.99833763425E-06 2.04892580467E-06 2.10079461816E-06 2.15397649426E-06 2.20850467323E-06 2.26441323677E-06 2.32173712938E-06 2.38051218017E-06 2.44077512527E-06 2.50256363076E-06 2.56591631628E-06 2.63087277907E-06 2.69747361880E-06 2.76576046293E-06 2.83577599268E-06 2.90756396977E-06 2.98116926373E-06 3.05663787997E-06 3.13401698851E-06 3.21335495348E-06 3.29470136334E-06 3.37810706187E-06 3.46362417997E-06 3.55130616821E-06 3.64120783027E-06 3.73338535716E-06 3.82789636236E-06 3.92479991784E-06 4.02415659096E-06 4.12602848233E-06 4.23047926462E-06 4.33757422237E-06 4.44738029278E-06 4.55996610756E-06 4.67540203581E-06 4.79376022800E-06 4.91511466110E-06 5.03954118476E-06 5.16711756876E-06 5.29792355160E-06 5.43204089033E-06 5.56955341167E-06 5.71054706439E-06 5.85510997302E-06 6.00333249293E-06 6.15530726682E-06 6.31112928261E-06 6.47089593279E-06 6.63470707532E-06 6.80266509604E-06 6.97487497261E-06 7.15144434021E-06 7.33248355872E-06 7.51810578176E-06 7.70842702736E-06 7.90356625053E-06 8.10364541753E-06 8.30878958218E-06 8.51912696395E-06 8.73478902813E-06 8.95591056799E-06 9.18262978901E-06 9.41508839527E-06 9.65343167802E-06 9.89780860645E-06 1.01483719208E-05 1.04052782280E-05 1.06686880990E-05 1.09387661700E-05 1.12156812445E-05 1.14996063992E-05 1.17907190922E-05 1.20892012737E-05 1.23952395000E-05 1.27090250499E-05 1.30307540440E-05 1.33606275679E-05 1.36988517973E-05 1.40456381270E-05 1.44012033034E-05 1.47657695591E-05 1.51395647529E-05 1.55228225111E-05 1.59157823744E-05 1.63186899470E-05 1.67317970503E-05 1.71553618805E-05 1.75896491696E-05 1.80349303509E-05 1.84914837288E-05 1.89595946527E-05 1.94395556951E-05 1.99316668348E-05 2.04362356439E-05 2.09535774806E-05 2.14840156856E-05 2.20278817847E-05 2.25855156958E-05 2.31572659413E-05 2.37434898657E-05 2.43445538594E-05 2.49608335872E-05 2.55927142231E-05 2.62405906914E-05 2.69048679130E-05 2.75859610587E-05 2.82842958085E-05 2.90003086177E-05 2.97344469895E-05 3.04871697551E-05 3.12589473595E-05 3.20502621565E-05 3.28616087092E-05 3.36934940997E-05 3.45464382457E-05 3.54209742252E-05 3.63176486099E-05 3.72370218066E-05 3.81796684073E-05 3.91461775481E-05 4.01371532778E-05 4.11532149347E-05 4.21949975342E-05 4.32631521648E-05 4.43583463956E-05 4.54812646933E-05 4.66326088493E-05 4.78130984188E-05 4.90234711701E-05 5.02644835454E-05 5.15369111338E-05 5.28415491555E-05 5.41792129586E-05 5.55507385289E-05 5.69569830116E-05 5.83988252473E-05 5.98771663207E-05 6.13929301237E-05 6.29470639325E-05 6.45405389993E-05 6.61743511592E-05 6.78495214520E-05 6.95670967604E-05 7.13281504637E-05 7.31337831083E-05 7.49851230952E-05 7.68833273849E-05 7.88295822200E-05 8.08251038661E-05 8.28711393716E-05 8.49689673466E-05 8.71198987613E-05 8.93252777651E-05 9.15864825259E-05 9.39049260909E-05 9.62820572690E-05 9.87193615358E-05 1.01218361961E-04 1.03780620161E-04 1.06407737270E-04 1.09101354946E-04 1.11863156391E-04 1.14694867404E-04 1.17598257458E-04 1.20575140805E-04 1.23627377612E-04 1.26756875115E-04 1.29965588818E-04 1.33255523708E-04 1.36628735510E-04 1.40087331970E-04 1.43633474170E-04 1.47269377876E-04 1.50997314924E-04 1.54819614637E-04 1.58738665279E-04 1.62756915543E-04 1.66876876085E-04 1.71101121087E-04 1.75432289865E-04 1.79873088514E-04 1.84426291600E-04 1.89094743891E-04 1.93881362131E-04 1.98789136859E-04 2.03821134279E-04 2.08980498167E-04 2.14270451842E-04 2.19694300165E-04 2.25255431611E-04 2.30957320379E-04 2.36803528557E-04 2.42797708348E-04 2.48943604347E-04 2.55245055872E-04 2.61705999368E-04 2.68330470852E-04 2.75122608436E-04 2.82086654907E-04 2.89226960369E-04 2.96547984958E-04 3.04054301626E-04 3.11750598983E-04 3.19641684230E-04 3.27732486148E-04 3.36028058173E-04 3.44533581548E-04 3.53254368546E-04 3.62195865788E-04 3.71363657629E-04 3.80763469644E-04 3.90401172192E-04 4.00282784075E-04 4.10414476283E-04 4.20802575843E-04 4.31453569758E-04 4.42374109043E-04 4.53571012873E-04 4.65051272824E-04 4.76822057228E-04 4.88890715635E-04 5.01264783386E-04 5.13951986307E-04 5.26960245513E-04 5.40297682340E-04 5.53972623395E-04 5.67993605739E-04 5.82369382194E-04 5.97108926792E-04 6.12221440349E-04 6.27716356193E-04 6.43603346024E-04 6.59892325929E-04 6.76593462545E-04 6.93717179376E-04 7.11274163269E-04 7.29275371058E-04 7.47732036367E-04 7.66655676585E-04 7.86058100025E-04 8.05951413247E-04 8.26348028581E-04 8.47260671826E-04 8.68702390151E-04 8.90686560187E-04 9.13226896327E-04 9.36337459231E-04 9.60032664543E-04 9.84327291835E-04 1.00923649376E-03 1.03477580544E-03 1.06096115412E-03 1.08780886897E-03 1.11533569128E-03 1.14355878477E-03 1.17249574620E-03 1.20216461633E-03 1.23258389101E-03 1.26377253267E-03 1.29574998200E-03 1.32853617002E-03 1.36215153035E-03 1.39661701188E-03 1.43195409165E-03 1.46818478818E-03 1.50533167500E-03 1.54341789463E-03 1.58246717283E-03 1.62250383323E-03 1.66355281232E-03 1.70563967485E-03 1.74879062954E-03 1.79303254523E-03 1.83839296744E-03 1.88490013529E-03 1.93258299889E-03 1.98147123713E-03 2.03159527591E-03 2.08298630686E-03 2.13567630646E-03 2.18969805567E-03 2.24508516009E-03 2.30187207047E-03 2.36009410391E-03 2.41978746545E-03 2.48098927027E-03 2.54373756633E-03 2.60807135774E-03 2.67403062851E-03 2.74165636703E-03 2.81099059107E-03 2.88207637343E-03 2.95495786820E-03 3.02968033766E-03 3.10629017986E-03 3.18483495682E-03 3.26536342352E-03 3.34792555746E-03 3.43257258905E-03 3.51935703272E-03 3.60833271868E-03 3.69955482565E-03 3.79307991415E-03 3.88896596080E-03 3.98727239334E-03 4.08806012648E-03 4.19139159869E-03 4.29733080984E-03 4.40594335971E-03 4.51729648748E-03 4.63145911213E-03 4.74850187384E-03 4.86849717635E-03 4.99151923031E-03 5.11764409775E-03 5.24694973752E-03 5.37951605182E-03 5.51542493390E-03 5.65476031682E-03 5.79760822335E-03 5.94405681714E-03 6.09419645500E-03 6.24811974044E-03 6.40592157847E-03 6.56769923167E-03 6.73355237761E-03 6.90358316751E-03 7.07789628635E-03 7.25659901438E-03 7.43980128994E-03 7.62761577388E-03 7.82015791533E-03 8.01754601903E-03 8.21990131425E-03 8.42734802517E-03 8.64001344294E-03 8.85802799934E-03 9.08152534215E-03 9.31064241211E-03 9.54551952170E-03 9.78630043569E-03 1.00331324534E-02 1.02861664927E-02 1.05455571764E-02 1.08114629195E-02 1.10840460196E-02 1.13634727483E-02 1.16499134450E-02 1.19435426126E-02 1.22445390157E-02 1.25530857799E-02 1.28693704944E-02 1.31935853159E-02 1.35259270750E-02 1.38665973851E-02 1.42158027528E-02 1.45737546914E-02 1.49406698363E-02 1.53167700627E-02 1.57022826063E-02 1.60974401851E-02 1.65024811251E-02 1.69176494878E-02 1.73431952000E-02 1.77793741863E-02 1.82264485045E-02 1.86846864833E-02 1.91543628622E-02 1.96357589347E-02 2.01291626937E-02 2.06348689798E-02 2.11531796320E-02 2.16844036415E-02 2.22288573075E-02 2.27868643966E-02 2.33587563040E-02 2.39448722182E-02 2.45455592879E-02 2.51611727918E-02 2.57920763109E-02 2.64386419040E-02 2.71012502851E-02 2.77802910042E-02 2.84761626302E-02 2.91892729367E-02 2.99200390902E-02 3.06688878409E-02 3.14362557159E-02 3.22225892149E-02 3.30283450082E-02 3.38539901370E-02 3.47000022158E-02 3.55668696375E-02 3.64550917793E-02 3.73651792121E-02 3.82976539103E-02 3.92530494643E-02 4.02319112939E-02 4.12347968637E-02 4.22622758991E-02 4.33149306037E-02 4.43933558779E-02 4.54981595375E-02 4.66299625335E-02 4.77893991713E-02 4.89771173309E-02 5.01937786860E-02 5.14400589227E-02 5.27166479575E-02 5.40242501542E-02 5.53635845387E-02 5.67353850122E-02 5.81404005625E-02 5.95793954714E-02 6.10531495198E-02 6.25624581890E-02 6.41081328572E-02 6.56910009918E-02 6.73119063361E-02 6.89717090899E-02 7.06712860838E-02 7.24115309461E-02 7.41933542610E-02 7.60176837193E-02 7.78854642581E-02 7.97976581910E-02 8.17552453260E-02 8.37592230723E-02 8.58106065322E-02 8.79104285797E-02 9.00597399234E-02 9.22596091517E-02 9.45111227616E-02 9.68153851666E-02 9.91735186852E-02 1.01586663507E-01 1.04055977633E-01 1.06582636797E-01 1.09167834351E-01 1.11812781129E-01 1.14518705281E-01 1.17286852065E-01 1.20118483618E-01 1.23014878683E-01 1.25977332296E-01 1.29007155436E-01 1.32105674633E-01 1.35274231523E-01 1.38514182365E-01 1.41826897498E-01 1.45213760750E-01 1.48676168788E-01 1.52215530407E-01 1.55833265760E-01 1.59530805523E-01 1.63309589981E-01 1.67171068054E-01 1.71116696240E-01 1.75147937476E-01 1.79266259923E-01 1.83473135653E-01 1.87770039255E-01 1.92158446337E-01 1.96639831932E-01 2.01215668798E-01 2.05887425610E-01 2.10656565040E-01 2.15524541713E-01 2.20492800050E-01 2.25562771976E-01 2.30735874497E-01 2.36013507144E-01 2.41397049271E-01 2.46887857205E-01 2.52487261253E-01 2.58196562540E-01 2.64017029696E-01 2.69949895371E-01 2.75996352583E-01 2.82157550889E-01 2.88434592374E-01 2.94828527463E-01 3.01340350536E-01 3.07970995365E-01 3.14721330339E-01 3.21592153510E-01 3.28584187423E-01 3.35698073756E-01 3.42934367747E-01 3.50293532425E-01 3.57775932631E-01 3.65381828834E-01 3.73111370751E-01 3.80964590759E-01 3.88941397114E-01 3.97041566977E-01 4.05264739253E-01 4.13610407249E-01 4.22077911163E-01 4.30666430405E-01 4.39374975778E-01 4.48202381512E-01 4.57147297180E-01 4.66208179515E-01 4.75383284131E-01 4.84670657189E-01 4.94068127018E-01 5.03573295728E-01 5.13183530836E-01 5.22895956938E-01 5.32707447464E-01 5.42614616559E-01 5.52613811120E-01 5.62701103033E-01 5.72872281674E-01 5.83122846703E-01 5.93448001216E-01 6.03842645308E-01 6.14301370117E-01 6.24818452392E-01 6.35387849672E-01 6.46003196132E-01 6.56657799179E-01 6.67344636855E-01 6.78056356149E-01 6.88785272272E-01 6.99523368993E-01 7.10262300107E-01 7.20993392121E-01 7.31707648242E-01 7.42395753744E-01 7.53048082790E-01 7.63654706804E-01 7.74205404436E-01 7.84689673222E-01 7.95096742984E-01 8.05415591024E-01 8.15634959184E-01 8.25743372783E-01 8.35729161486E-01 8.45580482106E-01 8.55285343354E-01 8.64831632520E-01 8.74207144058E-01 8.83399610040E-01 8.92396732391E-01 9.01186216855E-01 9.09755808541E-01 9.18093328958E-01 9.26186714356E-01 9.34024055196E-01 9.41593636551E-01 9.48883979189E-01 9.55883881084E-01 9.62582459054E-01 9.68969190228E-01 9.75033952972E-01 9.80767066930E-01 9.86159331767E-01 9.91202064222E-01 9.95887133008E-01 1.00020699115E+00 1.00415470524E+00 1.00772398125E+00 1.01090918622E+00 1.01370536564E+00 1.01610825579E+00 1.01811429070E+00 1.01972060334E+00 1.02092502053E+00 1.02172605125E+00 1.02212286800E+00 1.02211528094E+00 1.02170370455E+00 1.02088911670E+00 1.01967300996E+00 1.01805733529E+00 1.01604443810E+00 1.01363698687E+00 1.01083789486E+00 1.00765023510E+00 1.00407714951E+00 1.00012175284E+00 9.95787032244E-01 9.91075743947E-01 9.85990307985E-01 9.80532702818E-01 9.74704361494E-01 9.68506071392E-01 9.61937879800E-01 9.54999007817E-01 9.47687775298E-01 9.40001539742E-01 9.31936652239E-01 9.23488433634E-01 9.14651174165E-01 9.05418159667E-01 8.95781727278E-01 8.85733353069E-01 8.75263773421E-01 8.64363140932E-01 8.53021214362E-01 8.41227580311E-01 8.28971902131E-01 8.16244188735E-01 8.03035072605E-01 7.89336082202E-01 7.75139889283E-01 7.60440506185E-01 7.45233401981E-01 7.29515499686E-01 7.13285009309E-01 6.96541056260E-01 6.79283218647E-01 6.61511387571E-01 6.43225761454E-01 6.24426850482E-01 6.05115480890E-01 5.85292799088E-01 5.64960275610E-01 5.44119708859E-01 5.22773228635E-01 5.00923299416E-01 4.78572723376E-01 4.55724643121E-01 4.32382544112E-01 4.08550256767E-01 3.84231958218E-01 3.59432173721E-01 3.34155777689E-01 3.08407994370E-01 2.82194398159E-01 2.55520913552E-01 2.28393814776E-01 2.00819725110E-01 1.72805615949E-01 1.44358805653E-01 1.15486958254E-01 8.61980820889E-02 5.65005284559E-02 2.64029903819E-02 -4.08549837854E-03 -3.49555640004E-02 -6.61974927725E-02 -9.78012306799E-02 -1.29756382252E-01 -1.62052208548E-01 -1.94677624148E-01 -2.27621193047E-01 -2.60871123334E-01 -2.94415260583E-01 -3.28241079889E-01 -3.62335676513E-01 -3.96685755121E-01 -4.31277617661E-01 -4.66097149911E-01 -5.01129806821E-01 -5.36360596774E-01 -5.71774064944E-01 -6.07354275974E-01 -6.43084796228E-01 -6.78948675910E-01 -7.14928431385E-01 -7.51006028063E-01 -7.87162864227E-01 -8.23379756235E-01 -8.59636925503E-01 -8.95913987726E-01 -9.32189944770E-01 -9.68443179676E-01 -1.00465145519E+00 -1.04079191622E+00 -1.07684109665E+00 -1.11277493069E+00 -1.14856876924E+00 -1.18419740138E+00 -1.21963508110E+00 -1.25485555951E+00 -1.28983212246E+00 -1.32453763346E+00 -1.35894458187E+00 -1.39302513609E+00 -1.42675120137E+00 -1.46009448200E+00 -1.49302654733E+00 -1.52551890116E+00 -1.55754305385E+00 -1.58907059666E+00 -1.62007327765E+00 -1.65052307834E+00 -1.68039229065E+00 -1.70965359339E+00 -1.73828012757E+00 -1.76624557007E+00 -1.79352420491E+00 -1.82009099180E+00 -1.84592163126E+00 -1.87099262609E+00 -1.89528133873E+00 -1.91876604427E+00 -1.94142597885E+00 -1.96324138326E+00 -1.98419354185E+00 -2.00426481637E+00 -2.02343867507E+00 -2.04169971697E+00 -2.05903369145E+00 -2.07542751331E+00 -2.09086927347E+00 -2.10534824550E+00 -2.11885488832E+00 -2.13138084514E+00 -2.14291893903E+00 -2.15346316535E+00 -2.16300868126E+00 -2.17155179262E+00 -2.17908993854E+00 -2.18562167381E+00 -2.19114664945E+00 -2.19566559166E+00 -2.19918027931E+00 -2.20169352029E+00 -2.20320912679E+00 -2.20373188982E+00 -2.20326755304E+00 -2.20182278610E+00 -2.19940515763E+00 -2.19602310801E+00 -2.19168592199E+00 -2.18640370139E+00 -2.18018733775E+00 -2.17304848531E+00 -2.16499953404E+00 -2.15605358315E+00 -2.14622441477E+00 -2.13552646814E+00 -2.12397481418E+00 -2.11158513042E+00 -2.09837367654E+00 -2.08435727023E+00 -2.06955326360E+00 -2.05397952007E+00 -2.03765439166E+00 -2.02059669676E+00 -2.00282569835E+00 -1.98436108262E+00 -1.96522293794E+00 -1.94543173423E+00 -1.92500830265E+00 -1.90397381552E+00 -1.88234976657E+00 -1.86015795134E+00 -1.83742044781E+00 -1.81415959706E+00 -1.79039798412E+00 -1.76615841878E+00 -1.74146391642E+00 -1.71633767881E+00 -1.69080307475E+00 -1.66488362061E+00 -1.63860296071E+00 -1.61198484741E+00 -1.58505312097E+00 -1.55783168913E+00 -1.53034450628E+00 -1.50261555235E+00 -1.47466881123E+00 -1.44652824882E+00 -1.41821779062E+00 -1.38976129883E+00 -1.36118254907E+00 -1.33250520652E+00 -1.30375280168E+00 -1.27494870560E+00 -1.24611610463E+00 -1.21728130102E+00 -1.18850025588E+00 -1.15979612239E+00 -1.13118835432E+00 -1.10269630610E+00 -1.07433919780E+00 -1.04613608009E+00 -1.01810579915E+00 -9.90266961640E-01 -9.62637899949E-01 -9.35236637644E-01 -9.08080855392E-01 -8.81187857375E-01 -8.54574538340E-01 -8.28257351382E-01 -8.02252276572E-01 -7.76574790546E-01 -7.51239837156E-01 -7.26261799282E-01 -7.01654471928E-01 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 TDDFPT/Examples/pseudo/C.pz-rrkjus.UPF0000644000175000017500000175104012341371476015724 0ustar mbamba Generated using Andrea Dal Corso code (rrkj3) Author: Andrea Dal Corso Generation date: unknown Info: C LDA 2s2 2p2 RRKJ3 US 0 The Pseudo was generated with a Non-Relativistic Calculation 1.30000000000E+00 Local Potential cutoff radius nl pn l occ Rcut Rcut US E pseu 2S 1 0 2.00 1.30000000000 1.60000000000 0.00000000000 2S 1 0 0.00 1.30000000000 1.60000000000 0.00000000000 2P 2 1 2.00 1.30000000000 1.60000000000 0.00000000000 2P 2 1 0.00 1.30000000000 1.60000000000 0.00000000000 3D 3 2 -2.00 1.30000000000 1.30000000000 0.00000000000 0 Version Number C Element US Ultrasoft pseudopotential F Nonlinear Core Correction SLA PZ NOGX NOGC PZ Exchange-Correlation functional 4.00000000000 Z valence -10.68218164300 Total energy 0.0000000 0.0000000 Suggested cutoff for wfc and rho 2 Max angular momentum component 1425 Number of points in mesh 2 4 Number of Wavefunctions, Number of Projectors Wavefunctions nl l occ 2S 0 2.00 2P 1 2.00 1.12299116651E-03 1.13201112758E-03 1.14110353775E-03 1.15026897894E-03 1.15950803773E-03 1.16882130543E-03 1.17820937810E-03 1.18767285656E-03 1.19721234650E-03 1.20682845843E-03 1.21652180780E-03 1.22629301498E-03 1.23614270533E-03 1.24607150923E-03 1.25608006214E-03 1.26616900460E-03 1.27633898230E-03 1.28659064614E-03 1.29692465222E-03 1.30734166192E-03 1.31784234193E-03 1.32842736430E-03 1.33909740648E-03 1.34985315135E-03 1.36069528728E-03 1.37162450817E-03 1.38264151350E-03 1.39374700836E-03 1.40494170350E-03 1.41622631539E-03 1.42760156625E-03 1.43906818410E-03 1.45062690280E-03 1.46227846212E-03 1.47402360775E-03 1.48586309141E-03 1.49779767080E-03 1.50982810976E-03 1.52195517824E-03 1.53417965236E-03 1.54650231451E-03 1.55892395333E-03 1.57144536382E-03 1.58406734735E-03 1.59679071173E-03 1.60961627126E-03 1.62254484678E-03 1.63557726572E-03 1.64871436217E-03 1.66195697690E-03 1.67530595744E-03 1.68876215813E-03 1.70232644019E-03 1.71599967171E-03 1.72978272780E-03 1.74367649057E-03 1.75768184924E-03 1.77179970014E-03 1.78603094683E-03 1.80037650010E-03 1.81483727809E-03 1.82941420629E-03 1.84410821761E-03 1.85892025250E-03 1.87385125891E-03 1.88890219244E-03 1.90407401636E-03 1.91936770167E-03 1.93478422716E-03 1.95032457951E-03 1.96598975329E-03 1.98178075109E-03 1.99769858353E-03 2.01374426937E-03 2.02991883552E-03 2.04622331718E-03 2.06265875782E-03 2.07922620933E-03 2.09592673203E-03 2.11276139475E-03 2.12973127492E-03 2.14683745862E-03 2.16408104066E-03 2.18146312461E-03 2.19898482295E-03 2.21664725707E-03 2.23445155738E-03 2.25239886334E-03 2.27049032360E-03 2.28872709602E-03 2.30711034775E-03 2.32564125533E-03 2.34432100474E-03 2.36315079150E-03 2.38213182072E-03 2.40126530719E-03 2.42055247545E-03 2.43999455990E-03 2.45959280484E-03 2.47934846455E-03 2.49926280341E-03 2.51933709595E-03 2.53957262692E-03 2.55997069140E-03 2.58053259488E-03 2.60125965333E-03 2.62215319328E-03 2.64321455194E-03 2.66444507723E-03 2.68584612791E-03 2.70741907366E-03 2.72916529515E-03 2.75108618416E-03 2.77318314362E-03 2.79545758775E-03 2.81791094212E-03 2.84054464375E-03 2.86336014121E-03 2.88635889469E-03 2.90954237613E-03 2.93291206927E-03 2.95646946979E-03 2.98021608536E-03 3.00415343578E-03 3.02828305304E-03 3.05260648146E-03 3.07712527773E-03 3.10184101106E-03 3.12675526329E-03 3.15186962891E-03 3.17718571527E-03 3.20270514260E-03 3.22842954415E-03 3.25436056629E-03 3.28049986862E-03 3.30684912406E-03 3.33341001898E-03 3.36018425327E-03 3.38717354050E-03 3.41437960800E-03 3.44180419695E-03 3.46944906255E-03 3.49731597407E-03 3.52540671501E-03 3.55372308319E-03 3.58226689085E-03 3.61103996481E-03 3.64004414657E-03 3.66928129240E-03 3.69875327348E-03 3.72846197603E-03 3.75840930142E-03 3.78859716629E-03 3.81902750267E-03 3.84970225811E-03 3.88062339582E-03 3.91179289474E-03 3.94321274975E-03 3.97488497171E-03 4.00681158768E-03 4.03899464095E-03 4.07143619126E-03 4.10413831487E-03 4.13710310474E-03 4.17033267061E-03 4.20382913920E-03 4.23759465430E-03 4.27163137689E-03 4.30594148535E-03 4.34052717554E-03 4.37539066095E-03 4.41053417285E-03 4.44595996045E-03 4.48167029100E-03 4.51766744998E-03 4.55395374122E-03 4.59053148705E-03 4.62740302846E-03 4.66457072525E-03 4.70203695615E-03 4.73980411903E-03 4.77787463099E-03 4.81625092855E-03 4.85493546782E-03 4.89393072462E-03 4.93323919465E-03 4.97286339367E-03 5.01280585765E-03 5.05306914292E-03 5.09365582633E-03 5.13456850546E-03 5.17580979872E-03 5.21738234558E-03 5.25928880669E-03 5.30153186407E-03 5.34411422131E-03 5.38703860368E-03 5.43030775836E-03 5.47392445459E-03 5.51789148385E-03 5.56221166005E-03 5.60688781970E-03 5.65192282208E-03 5.69731954945E-03 5.74308090722E-03 5.78920982412E-03 5.83570925243E-03 5.88258216813E-03 5.92983157109E-03 5.97746048529E-03 6.02547195901E-03 6.07386906499E-03 6.12265490066E-03 6.17183258833E-03 6.22140527540E-03 6.27137613453E-03 6.32174836387E-03 6.37252518727E-03 6.42370985445E-03 6.47530564125E-03 6.52731584983E-03 6.57974380885E-03 6.63259287372E-03 6.68586642680E-03 6.73956787761E-03 6.79370066306E-03 6.84826824768E-03 6.90327412380E-03 6.95872181182E-03 7.01461486041E-03 7.07095684675E-03 7.12775137674E-03 7.18500208525E-03 7.24271263635E-03 7.30088672353E-03 7.35952806995E-03 7.41864042868E-03 7.47822758293E-03 7.53829334629E-03 7.59884156301E-03 7.65987610817E-03 7.72140088803E-03 7.78341984017E-03 7.84593693384E-03 7.90895617016E-03 7.97248158237E-03 8.03651723612E-03 8.10106722971E-03 8.16613569438E-03 8.23172679452E-03 8.29784472798E-03 8.36449372633E-03 8.43167805514E-03 8.49940201423E-03 8.56766993794E-03 8.63648619545E-03 8.70585519103E-03 8.77578136431E-03 8.84626919060E-03 8.91732318113E-03 8.98894788339E-03 9.06114788139E-03 9.13392779594E-03 9.20729228498E-03 9.28124604388E-03 9.35579380569E-03 9.43094034150E-03 9.50669046071E-03 9.58304901135E-03 9.66002088040E-03 9.73761099408E-03 9.81582431820E-03 9.89466585841E-03 9.97414066062E-03 1.00542538112E-02 1.01350104375E-02 1.02164157080E-02 1.02984748325E-02 1.03811930629E-02 1.04645756932E-02 1.05486280599E-02 1.06333555425E-02 1.07187635634E-02 1.08048575888E-02 1.08916431288E-02 1.09791257377E-02 1.10673110144E-02 1.11562046028E-02 1.12458121921E-02 1.13361395172E-02 1.14271923590E-02 1.15189765451E-02 1.16114979497E-02 1.17047624940E-02 1.17987761472E-02 1.18935449261E-02 1.19890748959E-02 1.20853721705E-02 1.21824429132E-02 1.22802933363E-02 1.23789297024E-02 1.24783583242E-02 1.25785855652E-02 1.26796178400E-02 1.27814616147E-02 1.28841234072E-02 1.29876097881E-02 1.30919273804E-02 1.31970828605E-02 1.33030829585E-02 1.34099344583E-02 1.35176441984E-02 1.36262190724E-02 1.37356660291E-02 1.38459920731E-02 1.39572042654E-02 1.40693097234E-02 1.41823156221E-02 1.42962291938E-02 1.44110577291E-02 1.45268085770E-02 1.46434891456E-02 1.47611069025E-02 1.48796693753E-02 1.49991841520E-02 1.51196588816E-02 1.52411012745E-02 1.53635191031E-02 1.54869202022E-02 1.56113124695E-02 1.57367038661E-02 1.58631024171E-02 1.59905162120E-02 1.61189534055E-02 1.62484222175E-02 1.63789309341E-02 1.65104879078E-02 1.66431015584E-02 1.67767803732E-02 1.69115329076E-02 1.70473677859E-02 1.71842937016E-02 1.73223194179E-02 1.74614537686E-02 1.76017056583E-02 1.77430840632E-02 1.78855980315E-02 1.80292566842E-02 1.81740692155E-02 1.83200448934E-02 1.84671930604E-02 1.86155231341E-02 1.87650446076E-02 1.89157670504E-02 1.90677001087E-02 1.92208535063E-02 1.93752370452E-02 1.95308606058E-02 1.96877341481E-02 1.98458677122E-02 2.00052714186E-02 2.01659554691E-02 2.03279301477E-02 2.04912058208E-02 2.06557929381E-02 2.08217020331E-02 2.09889437242E-02 2.11575287148E-02 2.13274677945E-02 2.14987718394E-02 2.16714518131E-02 2.18455187670E-02 2.20209838417E-02 2.21978582668E-02 2.23761533624E-02 2.25558805394E-02 2.27370513006E-02 2.29196772407E-02 2.31037700480E-02 2.32893415045E-02 2.34764034868E-02 2.36649679670E-02 2.38550470131E-02 2.40466527905E-02 2.42397975618E-02 2.44344936884E-02 2.46307536310E-02 2.48285899501E-02 2.50280153076E-02 2.52290424665E-02 2.54316842928E-02 2.56359537556E-02 2.58418639281E-02 2.60494279888E-02 2.62586592217E-02 2.64695710178E-02 2.66821768755E-02 2.68964904016E-02 2.71125253123E-02 2.73302954338E-02 2.75498147036E-02 2.77710971709E-02 2.79941569979E-02 2.82190084606E-02 2.84456659494E-02 2.86741439705E-02 2.89044571466E-02 2.91366202179E-02 2.93706480428E-02 2.96065555992E-02 2.98443579852E-02 3.00840704204E-02 3.03257082463E-02 3.05692869280E-02 3.08148220544E-02 3.10623293399E-02 3.13118246251E-02 3.15633238778E-02 3.18168431940E-02 3.20723987990E-02 3.23300070485E-02 3.25896844294E-02 3.28514475613E-02 3.31153131971E-02 3.33812982242E-02 3.36494196658E-02 3.39196946817E-02 3.41921405697E-02 3.44667747663E-02 3.47436148483E-02 3.50226785335E-02 3.53039836820E-02 3.55875482976E-02 3.58733905284E-02 3.61615286685E-02 3.64519811587E-02 3.67447665882E-02 3.70399036952E-02 3.73374113688E-02 3.76373086494E-02 3.79396147306E-02 3.82443489602E-02 3.85515308411E-02 3.88611800331E-02 3.91733163539E-02 3.94879597804E-02 3.98051304497E-02 4.01248486610E-02 4.04471348763E-02 4.07720097220E-02 4.10994939903E-02 4.14296086402E-02 4.17623747992E-02 4.20978137644E-02 4.24359470041E-02 4.27767961589E-02 4.31203830433E-02 4.34667296469E-02 4.38158581360E-02 4.41677908550E-02 4.45225503276E-02 4.48801592587E-02 4.52406405354E-02 4.56040172284E-02 4.59703125941E-02 4.63395500755E-02 4.67117533040E-02 4.70869461006E-02 4.74651524778E-02 4.78463966410E-02 4.82307029898E-02 4.86180961202E-02 4.90086008253E-02 4.94022420976E-02 4.97990451302E-02 5.01990353187E-02 5.06022382626E-02 5.10086797670E-02 5.14183858444E-02 5.18313827160E-02 5.22476968138E-02 5.26673547820E-02 5.30903834789E-02 5.35168099784E-02 5.39466615721E-02 5.43799657705E-02 5.48167503053E-02 5.52570431308E-02 5.57008724260E-02 5.61482665959E-02 5.65992542742E-02 5.70538643240E-02 5.75121258406E-02 5.79740681528E-02 5.84397208253E-02 5.89091136598E-02 5.93822766977E-02 5.98592402216E-02 6.03400347572E-02 6.08246910757E-02 6.13132401952E-02 6.18057133830E-02 6.23021421576E-02 6.28025582905E-02 6.33069938086E-02 6.38154809959E-02 6.43280523957E-02 6.48447408129E-02 6.53655793156E-02 6.58906012377E-02 6.64198401808E-02 6.69533300163E-02 6.74911048878E-02 6.80331992130E-02 6.85796476862E-02 6.91304852803E-02 6.96857472490E-02 7.02454691293E-02 7.08096867437E-02 7.13784362021E-02 7.19517539048E-02 7.25296765444E-02 7.31122411080E-02 7.36994848800E-02 7.42914454442E-02 7.48881606862E-02 7.54896687961E-02 7.60960082706E-02 7.67072179155E-02 7.73233368486E-02 7.79444045017E-02 7.85704606232E-02 7.92015452810E-02 7.98376988648E-02 8.04789620885E-02 8.11253759933E-02 8.17769819499E-02 8.24338216612E-02 8.30959371652E-02 8.37633708376E-02 8.44361653943E-02 8.51143638944E-02 8.57980097428E-02 8.64871466932E-02 8.71818188504E-02 8.78820706738E-02 8.85879469798E-02 8.92994929446E-02 9.00167541074E-02 9.07397763732E-02 9.14686060157E-02 9.22032896801E-02 9.29438743866E-02 9.36904075328E-02 9.44429368970E-02 9.52015106415E-02 9.59661773151E-02 9.67369858568E-02 9.75139855986E-02 9.82972262688E-02 9.90867579950E-02 9.98826313076E-02 1.00684897143E-01 1.01493606845E-01 1.02308812174E-01 1.03130565301E-01 1.03958918820E-01 1.04793925745E-01 1.05635639516E-01 1.06484114005E-01 1.07339403514E-01 1.08201562781E-01 1.09070646985E-01 1.09946711747E-01 1.10829813137E-01 1.11720007673E-01 1.12617352327E-01 1.13521904530E-01 1.14433722174E-01 1.15352863615E-01 1.16279387679E-01 1.17213353663E-01 1.18154821342E-01 1.19103850969E-01 1.20060503284E-01 1.21024839512E-01 1.21996921371E-01 1.22976811075E-01 1.23964571337E-01 1.24960265373E-01 1.25963956909E-01 1.26975710182E-01 1.27995589943E-01 1.29023661465E-01 1.30059990546E-01 1.31104643511E-01 1.32157687218E-01 1.33219189062E-01 1.34289216979E-01 1.35367839452E-01 1.36455125513E-01 1.37551144749E-01 1.38655967304E-01 1.39769663890E-01 1.40892305781E-01 1.42023964828E-01 1.43164713457E-01 1.44314624677E-01 1.45473772081E-01 1.46642229857E-01 1.47820072786E-01 1.49007376250E-01 1.50204216237E-01 1.51410669345E-01 1.52626812787E-01 1.53852724398E-01 1.55088482635E-01 1.56334166588E-01 1.57589855982E-01 1.58855631180E-01 1.60131573192E-01 1.61417763680E-01 1.62714284960E-01 1.64021220009E-01 1.65338652473E-01 1.66666666667E-01 1.68005347584E-01 1.69354780901E-01 1.70715052982E-01 1.72086250884E-01 1.73468462365E-01 1.74861775887E-01 1.76266280623E-01 1.77682066460E-01 1.79109224011E-01 1.80547844612E-01 1.81998020338E-01 1.83459843999E-01 1.84933409153E-01 1.86418810108E-01 1.87916141930E-01 1.89425500450E-01 1.90946982266E-01 1.92480684754E-01 1.94026706072E-01 1.95585145165E-01 1.97156101775E-01 1.98739676442E-01 2.00335970516E-01 2.01945086161E-01 2.03567126360E-01 2.05202194925E-01 2.06850396500E-01 2.08511836571E-01 2.10186621471E-01 2.11874858387E-01 2.13576655366E-01 2.15292121323E-01 2.17021366050E-01 2.18764500219E-01 2.20521635390E-01 2.22292884021E-01 2.24078359472E-01 2.25878176015E-01 2.27692448838E-01 2.29521294056E-01 2.31364828715E-01 2.33223170802E-01 2.35096439251E-01 2.36984753953E-01 2.38888235760E-01 2.40807006496E-01 2.42741188962E-01 2.44690906947E-01 2.46656285234E-01 2.48637449607E-01 2.50634526862E-01 2.52647644812E-01 2.54676932297E-01 2.56722519194E-01 2.58784536419E-01 2.60863115942E-01 2.62958390794E-01 2.65070495073E-01 2.67199563954E-01 2.69345733699E-01 2.71509141662E-01 2.73689926303E-01 2.75888227193E-01 2.78104185023E-01 2.80337941616E-01 2.82589639934E-01 2.84859424084E-01 2.87147439335E-01 2.89453832120E-01 2.91778750049E-01 2.94122341918E-01 2.96484757717E-01 2.98866148642E-01 3.01266667102E-01 3.03686466732E-01 3.06125702399E-01 3.08584530216E-01 3.11063107548E-01 3.13561593025E-01 3.16080146551E-01 3.18618929314E-01 3.21178103798E-01 3.23757833789E-01 3.26358284393E-01 3.28979622038E-01 3.31622014492E-01 3.34285630867E-01 3.36970641637E-01 3.39677218643E-01 3.42405535107E-01 3.45155765642E-01 3.47928086264E-01 3.50722674403E-01 3.53539708912E-01 3.56379370083E-01 3.59241839655E-01 3.62127300828E-01 3.65035938272E-01 3.67967938140E-01 3.70923488082E-01 3.73902777254E-01 3.76905996331E-01 3.79933337521E-01 3.82984994574E-01 3.86061162797E-01 3.89162039066E-01 3.92287821839E-01 3.95438711166E-01 3.98614908706E-01 4.01816617736E-01 4.05044043167E-01 4.08297391555E-01 4.11576871115E-01 4.14882691735E-01 4.18215064989E-01 4.21574204151E-01 4.24960324205E-01 4.28373641865E-01 4.31814375584E-01 4.35282745571E-01 4.38778973801E-01 4.42303284037E-01 4.45855901833E-01 4.49437054559E-01 4.53046971410E-01 4.56685883422E-01 4.60354023486E-01 4.64051626365E-01 4.67778928706E-01 4.71536169059E-01 4.75323587887E-01 4.79141427587E-01 4.82989932502E-01 4.86869348938E-01 4.90779925178E-01 4.94721911500E-01 4.98695560194E-01 5.02701125574E-01 5.06738863998E-01 5.10809033882E-01 5.14911895719E-01 5.19047712092E-01 5.23216747697E-01 5.27419269351E-01 5.31655546019E-01 5.35925848824E-01 5.40230451066E-01 5.44569628240E-01 5.48943658058E-01 5.53352820456E-01 5.57797397624E-01 5.62277674016E-01 5.66793936371E-01 5.71346473731E-01 5.75935577460E-01 5.80561541264E-01 5.85224661203E-01 5.89925235721E-01 5.94663565656E-01 5.99439954262E-01 6.04254707229E-01 6.09108132704E-01 6.14000541307E-01 6.18932246154E-01 6.23903562877E-01 6.28914809640E-01 6.33966307166E-01 6.39058378752E-01 6.44191350293E-01 6.49365550299E-01 6.54581309923E-01 6.59838962974E-01 6.65138845943E-01 6.70481298026E-01 6.75866661141E-01 6.81295279953E-01 6.86767501895E-01 6.92283677192E-01 6.97844158880E-01 7.03449302833E-01 7.09099467781E-01 7.14795015337E-01 7.20536310019E-01 7.26323719270E-01 7.32157613486E-01 7.38038366041E-01 7.43966353302E-01 7.49941954664E-01 7.55965552567E-01 7.62037532524E-01 7.68158283142E-01 7.74328196153E-01 7.80547666433E-01 7.86817092030E-01 7.93136874190E-01 7.99507417380E-01 8.05929129317E-01 8.12402420994E-01 8.18927706704E-01 8.25505404066E-01 8.32135934056E-01 8.38819721029E-01 8.45557192751E-01 8.52348780422E-01 8.59194918706E-01 8.66096045758E-01 8.73052603252E-01 8.80065036411E-01 8.87133794033E-01 8.94259328520E-01 9.01442095910E-01 9.08682555901E-01 9.15981171887E-01 9.23338410980E-01 9.30754744046E-01 9.38230645734E-01 9.45766594503E-01 9.53363072657E-01 9.61020566373E-01 9.68739565734E-01 9.76520564757E-01 9.84364061430E-01 9.92270557739E-01 1.00024055970E+00 1.00827457740E+00 1.01637312502E+00 1.02453672086E+00 1.03276588741E+00 1.04106115132E+00 1.04942304350E+00 1.05785209912E+00 1.06634885763E+00 1.07491386283E+00 1.08354766289E+00 1.09225081037E+00 1.10102386227E+00 1.10986738007E+00 1.11878192977E+00 1.12776808189E+00 1.13682641155E+00 1.14595749849E+00 1.15516192710E+00 1.16444028647E+00 1.17379317042E+00 1.18322117753E+00 1.19272491119E+00 1.20230497966E+00 1.21196199606E+00 1.22169657844E+00 1.23150934982E+00 1.24140093822E+00 1.25137197670E+00 1.26142310341E+00 1.27155496164E+00 1.28176819981E+00 1.29206347159E+00 1.30244143587E+00 1.31290275685E+00 1.32344810405E+00 1.33407815238E+00 1.34479358217E+00 1.35559507921E+00 1.36648333480E+00 1.37745904578E+00 1.38852291461E+00 1.39967564939E+00 1.41091796388E+00 1.42225057761E+00 1.43367421586E+00 1.44518960974E+00 1.45679749626E+00 1.46849861831E+00 1.48029372478E+00 1.49218357055E+00 1.50416891657E+00 1.51625052992E+00 1.52842918383E+00 1.54070565772E+00 1.55308073730E+00 1.56555521457E+00 1.57812988792E+00 1.59080556212E+00 1.60358304841E+00 1.61646316457E+00 1.62944673492E+00 1.64253459042E+00 1.65572756870E+00 1.66902651410E+00 1.68243227777E+00 1.69594571768E+00 1.70956769869E+00 1.72329909263E+00 1.73714077829E+00 1.75109364155E+00 1.76515857541E+00 1.77933648001E+00 1.79362826276E+00 1.80803483833E+00 1.82255712875E+00 1.83719606344E+00 1.85195257931E+00 1.86682762078E+00 1.88182213985E+00 1.89693709618E+00 1.91217345713E+00 1.92753219784E+00 1.94301430126E+00 1.95862075827E+00 1.97435256767E+00 1.99021073631E+00 2.00619627911E+00 2.02231021917E+00 2.03855358776E+00 2.05492742448E+00 2.07143277726E+00 2.08807070245E+00 2.10484226487E+00 2.12174853791E+00 2.13879060359E+00 2.15596955259E+00 2.17328648438E+00 2.19074250725E+00 2.20833873839E+00 2.22607630395E+00 2.24395633917E+00 2.26197998835E+00 2.28014840503E+00 2.29846275198E+00 2.31692420133E+00 2.33553393462E+00 2.35429314288E+00 2.37320302671E+00 2.39226479634E+00 2.41147967173E+00 2.43084888265E+00 2.45037366872E+00 2.47005527954E+00 2.48989497475E+00 2.50989402408E+00 2.53005370749E+00 2.55037531520E+00 2.57086014780E+00 2.59150951633E+00 2.61232474235E+00 2.63330715804E+00 2.65445810630E+00 2.67577894077E+00 2.69727102602E+00 2.71893573753E+00 2.74077446185E+00 2.76278859668E+00 2.78497955091E+00 2.80734874479E+00 2.82989760995E+00 2.85262758952E+00 2.87554013824E+00 2.89863672250E+00 2.92191882050E+00 2.94538792230E+00 2.96904552994E+00 2.99289315750E+00 3.01693233124E+00 3.04116458969E+00 3.06559148371E+00 3.09021457662E+00 3.11503544433E+00 3.14005567537E+00 3.16527687104E+00 3.19070064551E+00 3.21632862592E+00 3.24216245245E+00 3.26820377849E+00 3.29445427068E+00 3.32091560907E+00 3.34758948720E+00 3.37447761219E+00 3.40158170491E+00 3.42890350001E+00 3.45644474611E+00 3.48420720585E+00 3.51219265604E+00 3.54040288776E+00 3.56883970648E+00 3.59750493215E+00 3.62640039937E+00 3.65552795745E+00 3.68488947056E+00 3.71448681787E+00 3.74432189359E+00 3.77439660720E+00 3.80471288347E+00 3.83527266267E+00 3.86607790063E+00 3.89713056889E+00 3.92843265484E+00 3.95998616183E+00 3.99179310927E+00 4.02385553284E+00 4.05617548454E+00 4.08875503285E+00 4.12159626288E+00 4.15470127648E+00 4.18807219238E+00 4.22171114632E+00 4.25562029123E+00 4.28980179728E+00 4.32425785211E+00 4.35899066092E+00 4.39400244662E+00 4.42929544998E+00 4.46487192976E+00 4.50073416286E+00 4.53688444449E+00 4.57332508827E+00 4.61005842642E+00 4.64708680988E+00 4.68441260848E+00 4.72203821109E+00 4.75996602576E+00 4.79819847987E+00 4.83673802033E+00 4.87558711367E+00 4.91474824625E+00 4.95422392440E+00 4.99401667457E+00 5.03412904351E+00 5.07456359842E+00 5.11532292714E+00 5.15640963828E+00 5.19782636138E+00 5.23957574716E+00 5.28166046756E+00 5.32408321604E+00 5.36684670767E+00 5.40995367931E+00 5.45340688984E+00 5.49720912027E+00 5.54136317395E+00 5.58587187678E+00 5.63073807731E+00 5.67596464700E+00 5.72155448036E+00 5.76751049516E+00 5.81383563261E+00 5.86053285752E+00 5.90760515853E+00 5.95505554829E+00 6.00288706364E+00 6.05110276580E+00 6.09970574061E+00 6.14869909867E+00 6.19808597557E+00 6.24786953209E+00 6.29805295439E+00 6.34863945423E+00 6.39963226917E+00 6.45103466275E+00 6.50284992475E+00 6.55508137137E+00 6.60773234543E+00 6.66080621662E+00 6.71430638168E+00 6.76823626464E+00 6.82259931703E+00 6.87739901810E+00 6.93263887506E+00 6.98832242328E+00 7.04445322651E+00 7.10103487716E+00 7.15807099646E+00 7.21556523475E+00 7.27352127168E+00 7.33194281645E+00 7.39083360806E+00 7.45019741555E+00 7.51003803822E+00 7.57035930588E+00 7.63116507912E+00 7.69245924953E+00 7.75424573996E+00 7.81652850477E+00 7.87931153007E+00 7.94259883399E+00 8.00639446695E+00 8.07070251189E+00 8.13552708455E+00 8.20087233371E+00 8.26674244151E+00 8.33314162364E+00 8.40007412968E+00 8.46754424333E+00 8.53555628270E+00 8.60411460059E+00 8.67322358475E+00 8.74288765818E+00 8.81311127941E+00 8.88389894276E+00 8.95525517868E+00 9.02718455399E+00 9.09969167219E+00 9.17278117376E+00 9.24645773646E+00 9.32072607561E+00 9.39559094442E+00 9.47105713424E+00 9.54712947496E+00 9.62381283523E+00 9.70111212280E+00 9.77903228485E+00 9.85757830831E+00 9.93675522015E+00 1.00165680877E+01 1.00970220191E+01 1.01781221632E+01 1.02598737107E+01 1.03422818936E+01 1.04253519861E+01 1.05090893047E+01 1.05934992086E+01 1.06785871000E+01 1.07643584246E+01 1.08508186719E+01 1.09379733753E+01 1.10258281127E+01 1.11143885068E+01 1.12036602256E+01 1.12936489825E+01 1.13843605368E+01 1.14758006941E+01 1.15679753065E+01 1.16608902732E+01 1.17545515410E+01 1.18489651040E+01 1.19441370049E+01 1.20400733346E+01 1.21367802331E+01 1.22342638896E+01 1.23325305433E+01 1.24315864831E+01 1.25314380487E+01 1.26320916306E+01 1.27335536706E+01 1.28358306625E+01 1.29389291519E+01 1.30428557372E+01 1.31476170697E+01 1.32532198542E+01 1.33596708492E+01 1.34669768678E+01 1.35751447775E+01 1.36841815011E+01 1.37940940170E+01 1.39048893596E+01 1.40165746198E+01 1.41291569456E+01 1.42426435423E+01 1.43570416731E+01 1.44723586594E+01 1.45886018816E+01 1.47057787793E+01 1.48238968518E+01 1.49429636589E+01 1.50629868207E+01 1.51839740187E+01 1.53059329964E+01 1.54288715589E+01 1.55527975745E+01 1.56777189745E+01 1.58036437538E+01 1.59305799717E+01 1.60585357521E+01 1.61875192844E+01 1.63175388234E+01 1.64486026904E+01 1.65807192737E+01 1.67138970286E+01 1.68481444786E+01 1.69834702157E+01 1.71198829006E+01 1.72573912639E+01 1.73960041061E+01 1.75357302985E+01 1.76765787836E+01 1.78185585759E+01 1.79616787619E+01 1.81059485015E+01 1.82513770280E+01 1.83979736489E+01 1.85457477463E+01 1.86947087780E+01 1.88448662774E+01 1.89962298546E+01 1.91488091971E+01 1.93026140698E+01 1.94576543165E+01 1.96139398597E+01 1.97714807017E+01 1.99302869253E+01 2.00903686940E+01 2.02517362531E+01 2.04143999303E+01 2.05783701361E+01 2.07436573645E+01 2.09102721942E+01 2.10782252884E+01 2.12475273961E+01 2.14181893529E+01 2.15902220812E+01 2.17636365910E+01 2.19384439810E+01 2.21146554389E+01 2.22922822422E+01 2.24713357593E+01 2.26518274495E+01 2.28337688644E+01 2.30171716483E+01 2.32020475391E+01 2.33884083688E+01 2.35762660646E+01 2.37656326495E+01 2.39565202430E+01 2.41489410620E+01 2.43429074214E+01 2.45384317353E+01 2.47355265171E+01 2.49342043811E+01 2.51344780426E+01 2.53363603194E+01 2.55398641318E+01 2.57450025043E+01 2.59517885657E+01 2.61602355505E+01 2.63703567992E+01 2.65821657598E+01 2.67956759881E+01 2.70109011488E+01 2.72278550164E+01 2.74465514759E+01 2.76670045242E+01 2.78892282702E+01 2.81132369363E+01 2.83390448592E+01 2.85666664906E+01 2.87961163984E+01 2.90274092675E+01 2.92605599007E+01 2.94955832197E+01 2.97324942662E+01 2.99713082024E+01 3.02120403125E+01 3.04547060036E+01 3.06993208062E+01 3.09459003758E+01 3.11944604937E+01 3.14450170676E+01 3.16975861334E+01 3.19521838555E+01 3.22088265283E+01 3.24675305769E+01 3.27283125586E+01 3.29911891635E+01 3.32561772158E+01 3.35232936747E+01 3.37925556359E+01 3.40639803322E+01 3.43375851348E+01 3.46133875546E+01 3.48914052430E+01 3.51716559933E+01 3.54541577416E+01 3.57389285681E+01 3.60259866981E+01 3.63153505037E+01 3.66070385040E+01 3.69010693674E+01 3.71974619117E+01 3.74962351063E+01 3.77974080728E+01 3.81010000863E+01 3.84070305768E+01 3.87155191303E+01 3.90264854903E+01 3.93399495587E+01 3.96559313973E+01 3.99744512290E+01 4.02955294393E+01 4.06191865772E+01 4.09454433569E+01 4.12743206590E+01 4.16058395316E+01 4.19400211922E+01 4.22768870285E+01 4.26164585999E+01 4.29587576393E+01 4.33038060538E+01 4.36516259267E+01 4.40022395186E+01 4.43556692687E+01 4.47119377969E+01 4.50710679044E+01 4.54330825755E+01 4.57980049795E+01 4.61658584714E+01 4.65366665940E+01 4.69104530792E+01 4.72872418494E+01 4.76670570192E+01 4.80499228969E+01 4.84358639861E+01 4.88249049871E+01 4.92170707987E+01 4.96123865196E+01 5.00108774502E+01 5.04125690940E+01 5.08174871595E+01 5.12256575615E+01 5.16371064230E+01 5.20518600770E+01 5.24699450678E+01 5.28913881530E+01 5.33162163051E+01 5.37444567132E+01 5.41761367849E+01 5.46112841478E+01 5.50499266516E+01 5.54920923695E+01 5.59378096002E+01 5.63871068698E+01 5.68400129335E+01 5.72965567775E+01 5.77567676206E+01 5.82206749166E+01 5.86883083557E+01 5.91596978665E+01 5.96348736181E+01 6.01138660221E+01 6.05967057340E+01 6.10834236557E+01 6.15740509374E+01 6.20686189794E+01 6.25671594341E+01 6.30697042085E+01 6.35762854654E+01 6.40869356263E+01 6.46016873730E+01 6.51205736497E+01 6.56436276653E+01 6.61708828955E+01 6.67023730848E+01 6.72381322488E+01 6.77781946762E+01 6.83225949311E+01 6.88713678555E+01 6.94245485709E+01 6.99821724811E+01 7.05442752743E+01 7.11108929251E+01 7.16820616974E+01 7.22578181460E+01 7.28381991197E+01 7.34232417630E+01 7.40129835189E+01 7.46074621309E+01 7.52067156460E+01 7.58107824166E+01 7.64197011031E+01 7.70335106766E+01 7.76522504210E+01 7.82759599360E+01 7.89046791391E+01 7.95384482687E+01 8.01773078860E+01 8.08212988785E+01 8.14704624616E+01 8.21248401822E+01 8.27844739206E+01 8.34494058935E+01 8.41196786570E+01 8.47953351085E+01 8.54764184905E+01 8.61629723924E+01 8.68550407539E+01 8.75526678678E+01 8.82558983822E+01 8.89647773043E+01 8.96793500024E+01 9.03996622096E+01 9.11257600260E+01 9.18576899222E+01 9.25954987419E+01 9.33392337051E+01 9.40889424111E+01 9.48446728416E+01 9.56064733635E+01 9.63743927323E+01 9.71484800951E+01 9.79287849939E+01 9.87153573683E+01 9.95082475592E+01 8.98392933211E-06 9.05608902067E-06 9.12882830202E-06 9.20215183150E-06 9.27606430183E-06 9.35057044345E-06 9.42567502476E-06 9.50138285250E-06 9.57769877198E-06 9.65462766745E-06 9.73217446238E-06 9.81034411981E-06 9.88914164261E-06 9.96857207384E-06 1.00486404971E-05 1.01293520368E-05 1.02107118584E-05 1.02927251691E-05 1.03753972178E-05 1.04587332954E-05 1.05427387355E-05 1.06274189144E-05 1.07127792518E-05 1.07988252108E-05 1.08855622982E-05 1.09729960654E-05 1.10611321080E-05 1.11499760669E-05 1.12395336280E-05 1.13298105231E-05 1.14208125300E-05 1.15125454728E-05 1.16050152224E-05 1.16982276969E-05 1.17921888620E-05 1.18869047313E-05 1.19823813664E-05 1.20786248781E-05 1.21756414259E-05 1.22734372189E-05 1.23720185161E-05 1.24713916267E-05 1.25715629106E-05 1.26725387788E-05 1.27743256938E-05 1.28769301701E-05 1.29803587742E-05 1.30846181258E-05 1.31897148973E-05 1.32956558152E-05 1.34024476595E-05 1.35100972651E-05 1.36186115215E-05 1.37279973737E-05 1.38382618224E-05 1.39494119246E-05 1.40614547939E-05 1.41743976011E-05 1.42882475746E-05 1.44030120008E-05 1.45186982247E-05 1.46353136503E-05 1.47528657409E-05 1.48713620200E-05 1.49908100713E-05 1.51112175396E-05 1.52325921309E-05 1.53549416134E-05 1.54782738173E-05 1.56025966361E-05 1.57279180263E-05 1.58542460087E-05 1.59815886683E-05 1.61099541550E-05 1.62393506842E-05 1.63697865374E-05 1.65012700626E-05 1.66338096747E-05 1.67674138562E-05 1.69020911580E-05 1.70378501994E-05 1.71746996690E-05 1.73126483252E-05 1.74517049969E-05 1.75918785836E-05 1.77331780566E-05 1.78756124590E-05 1.80191909067E-05 1.81639225888E-05 1.83098167681E-05 1.84568827820E-05 1.86051300426E-05 1.87545680379E-05 1.89052063320E-05 1.90570545658E-05 1.92101224575E-05 1.93644198036E-05 1.95199564792E-05 1.96767424387E-05 1.98347877164E-05 1.99941024273E-05 2.01546967676E-05 2.03165810153E-05 2.04797655312E-05 2.06442607591E-05 2.08100772266E-05 2.09772255463E-05 2.11457164155E-05 2.13155606178E-05 2.14867690233E-05 2.16593525893E-05 2.18333223612E-05 2.20086894733E-05 2.21854651490E-05 2.23636607020E-05 2.25432875369E-05 2.27243571500E-05 2.29068811296E-05 2.30908711575E-05 2.32763390090E-05 2.34632965542E-05 2.36517557583E-05 2.38417286829E-05 2.40332274862E-05 2.42262644243E-05 2.44208518516E-05 2.46170022218E-05 2.48147280885E-05 2.50140421063E-05 2.52149570313E-05 2.54174857221E-05 2.56216411408E-05 2.58274363532E-05 2.60348845303E-05 2.62439989490E-05 2.64547929925E-05 2.66672801518E-05 2.68814740262E-05 2.70973883240E-05 2.73150368640E-05 2.75344335756E-05 2.77555925004E-05 2.79785277926E-05 2.82032537201E-05 2.84297846655E-05 2.86581351268E-05 2.88883197185E-05 2.91203531726E-05 2.93542503392E-05 2.95900261878E-05 2.98276958082E-05 3.00672744113E-05 3.03087773303E-05 3.05522200213E-05 3.07976180649E-05 3.10449871665E-05 3.12943431579E-05 3.15457019980E-05 3.17990797737E-05 3.20544927014E-05 3.23119571276E-05 3.25714895300E-05 3.28331065190E-05 3.30968248379E-05 3.33626613649E-05 3.36306331136E-05 3.39007572344E-05 3.41730510151E-05 3.44475318828E-05 3.47242174043E-05 3.50031252876E-05 3.52842733828E-05 3.55676796836E-05 3.58533623280E-05 3.61413395998E-05 3.64316299297E-05 3.67242518964E-05 3.70192242277E-05 3.73165658020E-05 3.76162956492E-05 3.79184329522E-05 3.82229970479E-05 3.85300074284E-05 3.88394837426E-05 3.91514457969E-05 3.94659135572E-05 3.97829071494E-05 4.01024468612E-05 4.04245531433E-05 4.07492466107E-05 4.10765480437E-05 4.14064783898E-05 4.17390587646E-05 4.20743104535E-05 4.24122549126E-05 4.27529137705E-05 4.30963088294E-05 4.34424620669E-05 4.37913956367E-05 4.41431318708E-05 4.44976932804E-05 4.48551025576E-05 4.52153825767E-05 4.55785563956E-05 4.59446472577E-05 4.63136785930E-05 4.66856740195E-05 4.70606573450E-05 4.74386525687E-05 4.78196838823E-05 4.82037756721E-05 4.85909525199E-05 4.89812392053E-05 4.93746607067E-05 4.97712422032E-05 5.01710090762E-05 5.05739869110E-05 5.09802014981E-05 5.13896788356E-05 5.18024451300E-05 5.22185267986E-05 5.26379504708E-05 5.30607429898E-05 5.34869314144E-05 5.39165430208E-05 5.43496053045E-05 5.47861459814E-05 5.52261929904E-05 5.56697744946E-05 5.61169188833E-05 5.65676547740E-05 5.70220110139E-05 5.74800166820E-05 5.79417010908E-05 5.84070937882E-05 5.88762245596E-05 5.93491234294E-05 5.98258206634E-05 6.03063467703E-05 6.07907325041E-05 6.12790088654E-05 6.17712071042E-05 6.22673587214E-05 6.27674954708E-05 6.32716493613E-05 6.37798526589E-05 6.42921378889E-05 6.48085378377E-05 6.53290855550E-05 6.58538143561E-05 6.63827578238E-05 6.69159498107E-05 6.74534244411E-05 6.79952161138E-05 6.85413595035E-05 6.90918895636E-05 6.96468415283E-05 7.02062509145E-05 7.07701535248E-05 7.13385854491E-05 7.19115830671E-05 7.24891830511E-05 7.30714223675E-05 7.36583382799E-05 7.42499683510E-05 7.48463504455E-05 7.54475227320E-05 7.60535236856E-05 7.66643920908E-05 7.72801670432E-05 7.79008879527E-05 7.85265945456E-05 7.91573268673E-05 7.97931252850E-05 8.04340304899E-05 8.10800835003E-05 8.17313256637E-05 8.23877986598E-05 8.30495445031E-05 8.37166055457E-05 8.43890244795E-05 8.50668443398E-05 8.57501085071E-05 8.64388607106E-05 8.71331450307E-05 8.78330059019E-05 8.85384881154E-05 8.92496368223E-05 8.99664975365E-05 9.06891161372E-05 9.14175388724E-05 9.21518123612E-05 9.28919835974E-05 9.36380999524E-05 9.43902091776E-05 9.51483594085E-05 9.59125991669E-05 9.66829773643E-05 9.74595433053E-05 9.82423466904E-05 9.90314376191E-05 9.98268665937E-05 1.00628684522E-04 1.01436942720E-04 1.02251692917E-04 1.03072987258E-04 1.03900878305E-04 1.04735419043E-04 1.05576662884E-04 1.06424663668E-04 1.07279475666E-04 1.08141153587E-04 1.09009752580E-04 1.09885328233E-04 1.10767936585E-04 1.11657634123E-04 1.12554477787E-04 1.13458524977E-04 1.14369833551E-04 1.15288461833E-04 1.16214468616E-04 1.17147913165E-04 1.18088855220E-04 1.19037355002E-04 1.19993473216E-04 1.20957271053E-04 1.21928810196E-04 1.22908152825E-04 1.23895361618E-04 1.24890499756E-04 1.25893630928E-04 1.26904819336E-04 1.27924129696E-04 1.28951627244E-04 1.29987377740E-04 1.31031447472E-04 1.32083903262E-04 1.33144812467E-04 1.34214242985E-04 1.35292263261E-04 1.36378942287E-04 1.37474349613E-04 1.38578555344E-04 1.39691630149E-04 1.40813645267E-04 1.41944672506E-04 1.43084784252E-04 1.44234053474E-04 1.45392553724E-04 1.46560359147E-04 1.47737544483E-04 1.48924185073E-04 1.50120356861E-04 1.51326136403E-04 1.52541600870E-04 1.53766828051E-04 1.55001896361E-04 1.56246884846E-04 1.57501873185E-04 1.58766941698E-04 1.60042171349E-04 1.61327643753E-04 1.62623441182E-04 1.63929646567E-04 1.65246343504E-04 1.66573616265E-04 1.67911549793E-04 1.69260229718E-04 1.70619742356E-04 1.71990174715E-04 1.73371614505E-04 1.74764150136E-04 1.76167870733E-04 1.77582866134E-04 1.79009226899E-04 1.80447044315E-04 1.81896410404E-04 1.83357417926E-04 1.84830160384E-04 1.86314732036E-04 1.87811227895E-04 1.89319743736E-04 1.90840376105E-04 1.92373222324E-04 1.93918380494E-04 1.95475949507E-04 1.97046029048E-04 1.98628719601E-04 2.00224122461E-04 2.01832339732E-04 2.03453474343E-04 2.05087630045E-04 2.06734911425E-04 2.08395423910E-04 2.10069273774E-04 2.11756568143E-04 2.13457415004E-04 2.15171923213E-04 2.16900202498E-04 2.18642363471E-04 2.20398517629E-04 2.22168777367E-04 2.23953255984E-04 2.25752067685E-04 2.27565327595E-04 2.29393151764E-04 2.31235657173E-04 2.33092961743E-04 2.34965184342E-04 2.36852444794E-04 2.38754863882E-04 2.40672563363E-04 2.42605665971E-04 2.44554295424E-04 2.46518576435E-04 2.48498634719E-04 2.50494597001E-04 2.52506591022E-04 2.54534745552E-04 2.56579190392E-04 2.58640056388E-04 2.60717475436E-04 2.62811580491E-04 2.64922505577E-04 2.67050385794E-04 2.69195357326E-04 2.71357557454E-04 2.73537124557E-04 2.75734198130E-04 2.77948918786E-04 2.80181428268E-04 2.82431869456E-04 2.84700386381E-04 2.86987124227E-04 2.89292229348E-04 2.91615849270E-04 2.93958132705E-04 2.96319229562E-04 2.98699290950E-04 3.01098469195E-04 3.03516917845E-04 3.05954791681E-04 3.08412246728E-04 3.10889440265E-04 3.13386530831E-04 3.15903678243E-04 3.18441043598E-04 3.20998789288E-04 3.23577079010E-04 3.26176077776E-04 3.28795951922E-04 3.31436869121E-04 3.34098998393E-04 3.36782510115E-04 3.39487576033E-04 3.42214369271E-04 3.44963064346E-04 3.47733837175E-04 3.50526865088E-04 3.53342326840E-04 3.56180402621E-04 3.59041274070E-04 3.61925124283E-04 3.64832137827E-04 3.67762500753E-04 3.70716400604E-04 3.73694026432E-04 3.76695568804E-04 3.79721219822E-04 3.82771173128E-04 3.85845623919E-04 3.88944768961E-04 3.92068806602E-04 3.95217936780E-04 3.98392361041E-04 4.01592282550E-04 4.04817906101E-04 4.08069438136E-04 4.11347086755E-04 4.14651061728E-04 4.17981574510E-04 4.21338838256E-04 4.24723067831E-04 4.28134479827E-04 4.31573292577E-04 4.35039726164E-04 4.38534002442E-04 4.42056345047E-04 4.45606979408E-04 4.49186132768E-04 4.52794034193E-04 4.56430914592E-04 4.60097006725E-04 4.63792545223E-04 4.67517766602E-04 4.71272909278E-04 4.75058213582E-04 4.78873921773E-04 4.82720278058E-04 4.86597528606E-04 4.90505921562E-04 4.94445707064E-04 4.98417137261E-04 5.02420466324E-04 5.06455950469E-04 5.10523847967E-04 5.14624419166E-04 5.18757926503E-04 5.22924634525E-04 5.27124809901E-04 5.31358721446E-04 5.35626640130E-04 5.39928839102E-04 5.44265593704E-04 5.48637181490E-04 5.53043882242E-04 5.57485977992E-04 5.61963753035E-04 5.66477493949E-04 5.71027489617E-04 5.75614031239E-04 5.80237412355E-04 5.84897928864E-04 5.89595879040E-04 5.94331563553E-04 5.99105285490E-04 6.03917350369E-04 6.08768066164E-04 6.13657743324E-04 6.18586694789E-04 6.23555236013E-04 6.28563684986E-04 6.33612362248E-04 6.38701590918E-04 6.43831696708E-04 6.49003007947E-04 6.54215855599E-04 6.59470573289E-04 6.64767497322E-04 6.70106966701E-04 6.75489323154E-04 6.80914911155E-04 6.86384077942E-04 6.91897173545E-04 6.97454550803E-04 7.03056565391E-04 7.08703575838E-04 7.14395943557E-04 7.20134032859E-04 7.25918210986E-04 7.31748848125E-04 7.37626317441E-04 7.43550995093E-04 7.49523260262E-04 7.55543495176E-04 7.61612085132E-04 7.67729418521E-04 7.73895886854E-04 7.80111884789E-04 7.86377810150E-04 7.92694063960E-04 7.99061050461E-04 8.05479177141E-04 8.11948854764E-04 8.18470497390E-04 8.25044522408E-04 8.31671350557E-04 8.38351405956E-04 8.45085116131E-04 8.51872912043E-04 8.58715228111E-04 8.65612502247E-04 8.72565175878E-04 8.79573693979E-04 8.86638505097E-04 8.93760061381E-04 9.00938818614E-04 9.08175236239E-04 9.15469777390E-04 9.22822908918E-04 9.30235101428E-04 9.37706829302E-04 9.45238570733E-04 9.52830807755E-04 9.60484026274E-04 9.68198716098E-04 9.75975370971E-04 9.83814488601E-04 9.91716570694E-04 9.99682122985E-04 1.00771165527E-03 1.01580568145E-03 1.02396471954E-03 1.03218929172E-03 1.04047992437E-03 1.04883714809E-03 1.05726149774E-03 1.06575351249E-03 1.07431373583E-03 1.08294271562E-03 1.09164100410E-03 1.10040915799E-03 1.10924773844E-03 1.11815731112E-03 1.12713844625E-03 1.13619171862E-03 1.14531770765E-03 1.15451699741E-03 1.16379017665E-03 1.17313783886E-03 1.18256058229E-03 1.19205901000E-03 1.20163372989E-03 1.21128535476E-03 1.22101450230E-03 1.23082179518E-03 1.24070786108E-03 1.25067333271E-03 1.26071884785E-03 1.27084504944E-03 1.28105258554E-03 1.29134210944E-03 1.30171427968E-03 1.31216976007E-03 1.32270921978E-03 1.33333333333E-03 1.34404278067E-03 1.35483824721E-03 1.36572042385E-03 1.37669000707E-03 1.38774769892E-03 1.39889420710E-03 1.41013024498E-03 1.42145653168E-03 1.43287379209E-03 1.44438275690E-03 1.45598416270E-03 1.46767875199E-03 1.47946727322E-03 1.49135048086E-03 1.50332913544E-03 1.51540400360E-03 1.52757585813E-03 1.53984547803E-03 1.55221364858E-03 1.56468116132E-03 1.57724881420E-03 1.58991741153E-03 1.60268776413E-03 1.61556068929E-03 1.62853701088E-03 1.64161755940E-03 1.65480317200E-03 1.66809469257E-03 1.68149297177E-03 1.69499886710E-03 1.70861324293E-03 1.72233697059E-03 1.73617092840E-03 1.75011600175E-03 1.76417308312E-03 1.77834307216E-03 1.79262687578E-03 1.80702540812E-03 1.82153959071E-03 1.83617035245E-03 1.85091862972E-03 1.86578536641E-03 1.88077151401E-03 1.89587803162E-03 1.91110588608E-03 1.92645605197E-03 1.94192951169E-03 1.95752725558E-03 1.97325028187E-03 1.98909959686E-03 2.00507621489E-03 2.02118115849E-03 2.03741545838E-03 2.05378015355E-03 2.07027629135E-03 2.08690492754E-03 2.10366712636E-03 2.12056396059E-03 2.13759651164E-03 2.15476586959E-03 2.17207313330E-03 2.18951941042E-03 2.20710581754E-03 2.22483348019E-03 2.24270353293E-03 2.26071711947E-03 2.27887539267E-03 2.29717951468E-03 2.31563065696E-03 2.33423000039E-03 2.35297873534E-03 2.37187806174E-03 2.39092918913E-03 2.41013333682E-03 2.42949173385E-03 2.44900561919E-03 2.46867624173E-03 2.48850486038E-03 2.50849274420E-03 2.52864117241E-03 2.54895143451E-03 2.56942483038E-03 2.59006267032E-03 2.61086627515E-03 2.63183697631E-03 2.65297611593E-03 2.67428504694E-03 2.69576513310E-03 2.71741774915E-03 2.73924428086E-03 2.76124612514E-03 2.78342469011E-03 2.80578139522E-03 2.82831767129E-03 2.85103496066E-03 2.87393471724E-03 2.89701840662E-03 2.92028750617E-03 2.94374350512E-03 2.96738790466E-03 2.99122221803E-03 3.01524797065E-03 3.03946670017E-03 3.06387995659E-03 3.08848930237E-03 3.11329631253E-03 3.13830257471E-03 3.16350968933E-03 3.18891926965E-03 3.21453294189E-03 3.24035234534E-03 3.26637913244E-03 3.29261496892E-03 3.31906153388E-03 3.34572051992E-03 3.37259363320E-03 3.39968259364E-03 3.42698913492E-03 3.45451500467E-03 3.48226196456E-03 3.51023179041E-03 3.53842627229E-03 3.56684721466E-03 3.59549643647E-03 3.62437577128E-03 3.65348706737E-03 3.68283218789E-03 3.71241301092E-03 3.74223142965E-03 3.77228935247E-03 3.80258870309E-03 3.83313142070E-03 3.86391946002E-03 3.89495479150E-03 3.92623940142E-03 3.95777529200E-03 3.98956448156E-03 4.02160900460E-03 4.05391091199E-03 4.08647227106E-03 4.11929516575E-03 4.15238169674E-03 4.18573398157E-03 4.21935415481E-03 4.25324436815E-03 4.28740679059E-03 4.32184360852E-03 4.35655702592E-03 4.39154926446E-03 4.42682256365E-03 4.46237918099E-03 4.49822139213E-03 4.53435149097E-03 4.57077178985E-03 4.60748461968E-03 4.64449233011E-03 4.68179728963E-03 4.71940188577E-03 4.75730852525E-03 4.79551963409E-03 4.83403765783E-03 4.87286506163E-03 4.91200433046E-03 4.95145796923E-03 4.99122850301E-03 5.03131847712E-03 5.07173045733E-03 5.11246703002E-03 5.15353080234E-03 5.19492440239E-03 5.23665047938E-03 5.27871170379E-03 5.32111076755E-03 5.36385038421E-03 5.40693328913E-03 5.45036223962E-03 5.49414001516E-03 5.53826941753E-03 5.58275327104E-03 5.62759442266E-03 5.67279574225E-03 5.71836012270E-03 5.76429048015E-03 5.81058975416E-03 5.85726090789E-03 5.90430692832E-03 5.95173082642E-03 5.99953563731E-03 6.04772442054E-03 6.09630026019E-03 6.14526626514E-03 6.19462556923E-03 6.24438133147E-03 6.29453673624E-03 6.34509499352E-03 6.39605933904E-03 6.44743303454E-03 6.49921936796E-03 6.55142165363E-03 6.60404323253E-03 6.65708747244E-03 6.71055776823E-03 6.76445754201E-03 6.81879024338E-03 6.87355934965E-03 6.92876836606E-03 6.98442082602E-03 7.04052029129E-03 7.09707035226E-03 7.15407462816E-03 7.21153676728E-03 7.26946044721E-03 7.32784937509E-03 7.38670728784E-03 7.44603795237E-03 7.50584516587E-03 7.56613275602E-03 7.62690458126E-03 7.68816453099E-03 7.74991652587E-03 7.81216451806E-03 7.87491249144E-03 7.93816446191E-03 8.00192447761E-03 8.06619661922E-03 8.13098500016E-03 8.19629376691E-03 8.26212709927E-03 8.32848921057E-03 8.39538434804E-03 8.46281679296E-03 8.53079086105E-03 8.59931090266E-03 8.66838130311E-03 8.73800648292E-03 8.80819089813E-03 8.87893904056E-03 8.95025543812E-03 9.02214465509E-03 9.09461129239E-03 9.16765998792E-03 9.24129541681E-03 9.31552229177E-03 9.39034536334E-03 9.46576942021E-03 9.54179928956E-03 9.61843983731E-03 9.69569596851E-03 9.77357262755E-03 9.85207479857E-03 9.93120750575E-03 1.00109758136E-02 1.00913848273E-02 1.01724396931E-02 1.02541455985E-02 1.03365077727E-02 1.04195314870E-02 1.05032220548E-02 1.05875848324E-02 1.06726252191E-02 1.07583486574E-02 1.08447606337E-02 1.09318666784E-02 1.10196723662E-02 1.11081833169E-02 1.11974051951E-02 1.12873437111E-02 1.13780046209E-02 1.14693937269E-02 1.15615168780E-02 1.16543799701E-02 1.17479889465E-02 1.18423497982E-02 1.19374685644E-02 1.20333513326E-02 1.21300042394E-02 1.22274334706E-02 1.23256452617E-02 1.24246458984E-02 1.25244417166E-02 1.26250391034E-02 1.27264444969E-02 1.28286643873E-02 1.29317053166E-02 1.30355738794E-02 1.31402767234E-02 1.32458205496E-02 1.33522121128E-02 1.34594582221E-02 1.35675657414E-02 1.36765415896E-02 1.37863927410E-02 1.38971262263E-02 1.40087491324E-02 1.41212686032E-02 1.42346918401E-02 1.43490261021E-02 1.44642787066E-02 1.45804570300E-02 1.46975685075E-02 1.48156206345E-02 1.49346209662E-02 1.50545771188E-02 1.51754967694E-02 1.52973876571E-02 1.54202575827E-02 1.55441144101E-02 1.56689660661E-02 1.57948205414E-02 1.59216858905E-02 1.60495702329E-02 1.61784817533E-02 1.63084287021E-02 1.64394193959E-02 1.65714622181E-02 1.67045656196E-02 1.68387381189E-02 1.69739883033E-02 1.71103248287E-02 1.72477564207E-02 1.73862918751E-02 1.75259400580E-02 1.76667099071E-02 1.78086104316E-02 1.79516507133E-02 1.80958399068E-02 1.82411872402E-02 1.83877020158E-02 1.85353936106E-02 1.86842714770E-02 1.88343451431E-02 1.89856242137E-02 1.91381183707E-02 1.92918373739E-02 1.94467910612E-02 1.96029893498E-02 1.97604422364E-02 1.99191597980E-02 2.00791521927E-02 2.02404296599E-02 2.04030025216E-02 2.05668811824E-02 2.07320761306E-02 2.08985979388E-02 2.10664572643E-02 2.12356648504E-02 2.14062315262E-02 2.15781682081E-02 2.17514859002E-02 2.19261956948E-02 2.21023087734E-02 2.22798364073E-02 2.24587899584E-02 2.26391808796E-02 2.28210207162E-02 2.30043211059E-02 2.31890937800E-02 2.33753505640E-02 2.35631033784E-02 2.37523642395E-02 2.39431452600E-02 2.41354586500E-02 2.43293167175E-02 2.45247318696E-02 2.47217166130E-02 2.49202835546E-02 2.51204454029E-02 2.53222149683E-02 2.55256051641E-02 2.57306290073E-02 2.59372996196E-02 2.61456302279E-02 2.63556341655E-02 2.65673248726E-02 2.67807158976E-02 2.69958208975E-02 2.72126536392E-02 2.74312280001E-02 2.76515579689E-02 2.78736576468E-02 2.80975412483E-02 2.83232231021E-02 2.85507176518E-02 2.87800394572E-02 2.90112031949E-02 2.92442236596E-02 2.94791157645E-02 2.97158945429E-02 2.99545751487E-02 3.01951728576E-02 3.04377030678E-02 3.06821813014E-02 3.09286232050E-02 3.11770445512E-02 3.14274612388E-02 3.16798892946E-02 3.19343448742E-02 3.21908442627E-02 3.24494038763E-02 3.27100402628E-02 3.29727701031E-02 3.32376102118E-02 3.35045775390E-02 3.37736891706E-02 3.40449623298E-02 3.43184143782E-02 3.45940628169E-02 3.48719252874E-02 3.51520195730E-02 3.54343635998E-02 3.57189754381E-02 3.60058733029E-02 3.62950755559E-02 3.65866007062E-02 3.68804674114E-02 3.71766944790E-02 3.74753008679E-02 3.77763056887E-02 3.80797282061E-02 3.83855878390E-02 3.86939041626E-02 3.90046969094E-02 3.93179859700E-02 3.96337913952E-02 3.99521333965E-02 4.02730323480E-02 4.05965087874E-02 4.09225834171E-02 4.12512771062E-02 4.15826108911E-02 4.19166059772E-02 4.22532837405E-02 4.25926657283E-02 4.29347736613E-02 4.32796294345E-02 4.36272551187E-02 4.39776729621E-02 4.43309053916E-02 4.46869750142E-02 4.50459046185E-02 4.54077171760E-02 4.57724358429E-02 4.61400839613E-02 4.65106850609E-02 4.68842628601E-02 4.72608412682E-02 4.76404443863E-02 4.80230965091E-02 4.84088221264E-02 4.87976459249E-02 4.91895927894E-02 4.95846878046E-02 4.99829562567E-02 5.03844236351E-02 5.07891156339E-02 5.11970581533E-02 5.16082773020E-02 5.20227993980E-02 5.24406509709E-02 5.28618587634E-02 5.32864497329E-02 5.37144510534E-02 5.41458901171E-02 5.45807945362E-02 5.50191921448E-02 5.54611110005E-02 5.59065793862E-02 5.63556258121E-02 5.68082790173E-02 5.72645679717E-02 5.77245218780E-02 5.81881701734E-02 5.86555425316E-02 5.91266688645E-02 5.96015793244E-02 6.00803043057E-02 6.05628744470E-02 6.10493206330E-02 6.15396739963E-02 6.20339659197E-02 6.25322280382E-02 6.30344922405E-02 6.35407906719E-02 6.40511557356E-02 6.45656200951E-02 6.50842166764E-02 6.56069786697E-02 6.61339395320E-02 6.66651329891E-02 6.72005930374E-02 6.77403539466E-02 6.82844502616E-02 6.88329168047E-02 6.93857886780E-02 6.99431012655E-02 7.05048902353E-02 7.10711915421E-02 7.16420414295E-02 7.22174764319E-02 7.27975333775E-02 7.33822493901E-02 7.39716618917E-02 7.45658086049E-02 7.51647275553E-02 7.57684570740E-02 7.63770357997E-02 7.69905026818E-02 7.76088969824E-02 7.82322582788E-02 7.88606264665E-02 7.94940417612E-02 8.01325447017E-02 8.07761761524E-02 8.14249773060E-02 8.20789896859E-02 8.27382551492E-02 8.34028158890E-02 8.40727144375E-02 8.47479936685E-02 8.54286967999E-02 8.61148673971E-02 8.68065493753E-02 8.75037870022E-02 8.82066249013E-02 8.89151080546E-02 8.96292818051E-02 9.03491918602E-02 9.10748842945E-02 9.18064055524E-02 9.25438024517E-02 9.32871221859E-02 9.40364123277E-02 9.47917208320E-02 9.55530960389E-02 9.63205866764E-02 9.70942418644E-02 9.78741111171E-02 9.86602443462E-02 9.94526918647E-02 1.00251504389E-01 1.01056733045E-01 1.01868429365E-01 1.02686645300E-01 1.03511433215E-01 1.04342845897E-01 1.05180936557E-01 1.06025758833E-01 1.06877366794E-01 1.07735814942E-01 1.08601158220E-01 1.09473452009E-01 1.10352752136E-01 1.11239114876E-01 1.12132596959E-01 1.13033255565E-01 1.13941148339E-01 1.14856333385E-01 1.15778869275E-01 1.16708815053E-01 1.17646230234E-01 1.18591174815E-01 1.19543709271E-01 1.20503894565E-01 1.21471792150E-01 1.22447463971E-01 1.23430972471E-01 1.24422380596E-01 1.25421751796E-01 1.26429150030E-01 1.27444639773E-01 1.28468286017E-01 1.29500154275E-01 1.30540310587E-01 1.31588821523E-01 1.32645754189E-01 1.33711176229E-01 1.34785155829E-01 1.35867761725E-01 1.36959063205E-01 1.38059130111E-01 1.39168032849E-01 1.40285842388E-01 1.41412630269E-01 1.42548468607E-01 1.43693430095E-01 1.44847588012E-01 1.46011016224E-01 1.47183789191E-01 1.48365981971E-01 1.49557670224E-01 1.50758930219E-01 1.51969838837E-01 1.53190473576E-01 1.54420912559E-01 1.55661234532E-01 1.56911518877E-01 1.58171845614E-01 1.59442295402E-01 1.60722949552E-01 1.62013890025E-01 1.63315199443E-01 1.64626961089E-01 1.65949258916E-01 1.67282177553E-01 1.68625802307E-01 1.69980219169E-01 1.71345514824E-01 1.72721776649E-01 1.74109092728E-01 1.75507551848E-01 1.76917243511E-01 1.78338257938E-01 1.79770686074E-01 1.81214619596E-01 1.82670150915E-01 1.84137373187E-01 1.85616380312E-01 1.87107266950E-01 1.88610128517E-01 1.90125061196E-01 1.91652161944E-01 1.93191528496E-01 1.94743259371E-01 1.96307453882E-01 1.97884212137E-01 1.99473635049E-01 2.01075824341E-01 2.02690882555E-01 2.04318913055E-01 2.05960020035E-01 2.07614308526E-01 2.09281884404E-01 2.10962854394E-01 2.12657326079E-01 2.14365407905E-01 2.16087209190E-01 2.17822840131E-01 2.19572411808E-01 2.21336036194E-01 2.23113826161E-01 2.24905895490E-01 2.26712358873E-01 2.28533331925E-01 2.30368931187E-01 2.32219274140E-01 2.34084479206E-01 2.35964665758E-01 2.37859954129E-01 2.39770465619E-01 2.41696322500E-01 2.43637648029E-01 2.45594566450E-01 2.47567203007E-01 2.49555683949E-01 2.51560136541E-01 2.53580689067E-01 2.55617470844E-01 2.57670612226E-01 2.59740244615E-01 2.61826500469E-01 2.63929513308E-01 2.66049417726E-01 2.68186349398E-01 2.70340445087E-01 2.72511842657E-01 2.74700681078E-01 2.76907100437E-01 2.79131241944E-01 2.81373247947E-01 2.83633261933E-01 2.85911428544E-01 2.88207893585E-01 2.90522804029E-01 2.92856308032E-01 2.95208554939E-01 2.97579695294E-01 2.99969880851E-01 3.02379264582E-01 3.04808000690E-01 3.07256244614E-01 3.09724153043E-01 3.12211883923E-01 3.14719596470E-01 3.17247451178E-01 3.19795609832E-01 3.22364235514E-01 3.24953492618E-01 3.27563546855E-01 3.30194565272E-01 3.32846716253E-01 3.35520169538E-01 3.38215096228E-01 3.40931668800E-01 3.43670061114E-01 3.46430448431E-01 3.49213007414E-01 3.52017916148E-01 3.54845354150E-01 3.57695502375E-01 3.60568543235E-01 3.63464660604E-01 3.66384039836E-01 3.69326867771E-01 3.72293332752E-01 3.75283624634E-01 3.78297934795E-01 3.81336456153E-01 3.84399383175E-01 3.87486911889E-01 3.90599239897E-01 3.93736566389E-01 3.96899092157E-01 4.00087019602E-01 4.03300552752E-01 4.06539897276E-01 4.09805260492E-01 4.13096851384E-01 4.16414880616E-01 4.19759560542E-01 4.23131105224E-01 4.26529730440E-01 4.29955653705E-01 4.33409094279E-01 4.36890273183E-01 4.40399413213E-01 4.43936738956E-01 4.47502476802E-01 4.51096854959E-01 4.54720103468E-01 4.58372454220E-01 4.62054140965E-01 4.65765399333E-01 4.69506466845E-01 4.73277582932E-01 4.77078988945E-01 4.80910928177E-01 4.84773645872E-01 4.88667389246E-01 4.92592407499E-01 4.96548951835E-01 5.00537275473E-01 5.04557633668E-01 5.08610283723E-01 5.12695485010E-01 5.16813498984E-01 5.20964589197E-01 5.25149021322E-01 5.29367063164E-01 5.33618984679E-01 5.37905057990E-01 5.42225557409E-01 5.46580759449E-01 5.50970942844E-01 5.55396388567E-01 5.59857379849E-01 5.64354202194E-01 5.68887143401E-01 5.73456493579E-01 5.78062545168E-01 5.82705592958E-01 5.87385934104E-01 5.92103868151E-01 5.96859697047E-01 6.01653725168E-01 6.06486259333E-01 6.11357608825E-01 6.16268085413E-01 6.21218003368E-01 6.26207679488E-01 6.31237433113E-01 6.36307586149E-01 6.41418463088E-01 6.46570391028E-01 6.51763699693E-01 6.56998721458E-01 6.62275791365E-01 6.67595247148E-01 6.72957429256E-01 6.78362680868E-01 6.83811347924E-01 6.89303779139E-01 6.94840326032E-01 7.00421342942E-01 7.06047187058E-01 7.11718218434E-01 7.17434800019E-01 7.23197297677E-01 7.29006080208E-01 7.34861519378E-01 7.40763989935E-01 7.46713869641E-01 7.52711539289E-01 7.58757382733E-01 7.64851786908E-01 7.70995141858E-01 7.77187840761E-01 7.83430279951E-01 7.89722858946E-01 7.96065980474E-01 -1.67866385670E+01 -1.67866382638E+01 -1.67866379557E+01 -1.67866376425E+01 -1.67866373244E+01 -1.67866370011E+01 -1.67866366726E+01 -1.67866363388E+01 -1.67866359996E+01 -1.67866356550E+01 -1.67866353047E+01 -1.67866349489E+01 -1.67866345873E+01 -1.67866342199E+01 -1.67866338465E+01 -1.67866334671E+01 -1.67866330816E+01 -1.67866326899E+01 -1.67866322919E+01 -1.67866318874E+01 -1.67866314765E+01 -1.67866310589E+01 -1.67866306345E+01 -1.67866302033E+01 -1.67866297652E+01 -1.67866293200E+01 -1.67866288676E+01 -1.67866284080E+01 -1.67866279409E+01 -1.67866274663E+01 -1.67866269840E+01 -1.67866264939E+01 -1.67866259960E+01 -1.67866254900E+01 -1.67866249759E+01 -1.67866244534E+01 -1.67866239226E+01 -1.67866233831E+01 -1.67866228350E+01 -1.67866222781E+01 -1.67866217121E+01 -1.67866211371E+01 -1.67866205527E+01 -1.67866199589E+01 -1.67866193556E+01 -1.67866187425E+01 -1.67866181196E+01 -1.67866174866E+01 -1.67866168434E+01 -1.67866161898E+01 -1.67866155257E+01 -1.67866148508E+01 -1.67866141651E+01 -1.67866134684E+01 -1.67866127603E+01 -1.67866120409E+01 -1.67866113099E+01 -1.67866105671E+01 -1.67866098123E+01 -1.67866090453E+01 -1.67866082660E+01 -1.67866074741E+01 -1.67866066694E+01 -1.67866058518E+01 -1.67866050209E+01 -1.67866041767E+01 -1.67866033189E+01 -1.67866024472E+01 -1.67866015615E+01 -1.67866006614E+01 -1.67865997469E+01 -1.67865988176E+01 -1.67865978734E+01 -1.67865969139E+01 -1.67865959390E+01 -1.67865949483E+01 -1.67865939416E+01 -1.67865929187E+01 -1.67865918794E+01 -1.67865908232E+01 -1.67865897501E+01 -1.67865886596E+01 -1.67865875515E+01 -1.67865864256E+01 -1.67865852815E+01 -1.67865841190E+01 -1.67865829378E+01 -1.67865817374E+01 -1.67865805178E+01 -1.67865792784E+01 -1.67865780191E+01 -1.67865767395E+01 -1.67865754393E+01 -1.67865741180E+01 -1.67865727755E+01 -1.67865714114E+01 -1.67865700252E+01 -1.67865686167E+01 -1.67865671855E+01 -1.67865657312E+01 -1.67865642534E+01 -1.67865627519E+01 -1.67865612261E+01 -1.67865596757E+01 -1.67865581003E+01 -1.67865564996E+01 -1.67865548730E+01 -1.67865532202E+01 -1.67865515407E+01 -1.67865498342E+01 -1.67865481002E+01 -1.67865463382E+01 -1.67865445478E+01 -1.67865427285E+01 -1.67865408799E+01 -1.67865390015E+01 -1.67865370928E+01 -1.67865351534E+01 -1.67865331826E+01 -1.67865311802E+01 -1.67865291454E+01 -1.67865270778E+01 -1.67865249769E+01 -1.67865228421E+01 -1.67865206730E+01 -1.67865184688E+01 -1.67865162291E+01 -1.67865139533E+01 -1.67865116409E+01 -1.67865092911E+01 -1.67865069035E+01 -1.67865044774E+01 -1.67865020122E+01 -1.67864995072E+01 -1.67864969619E+01 -1.67864943755E+01 -1.67864917475E+01 -1.67864890771E+01 -1.67864863636E+01 -1.67864836065E+01 -1.67864808048E+01 -1.67864779581E+01 -1.67864750654E+01 -1.67864721261E+01 -1.67864691395E+01 -1.67864661047E+01 -1.67864630210E+01 -1.67864598876E+01 -1.67864567037E+01 -1.67864534685E+01 -1.67864501811E+01 -1.67864468408E+01 -1.67864434466E+01 -1.67864399978E+01 -1.67864364933E+01 -1.67864329324E+01 -1.67864293141E+01 -1.67864256375E+01 -1.67864219017E+01 -1.67864181056E+01 -1.67864142484E+01 -1.67864103290E+01 -1.67864063465E+01 -1.67864022998E+01 -1.67863981879E+01 -1.67863940098E+01 -1.67863897643E+01 -1.67863854504E+01 -1.67863810670E+01 -1.67863766130E+01 -1.67863720873E+01 -1.67863674886E+01 -1.67863628158E+01 -1.67863580678E+01 -1.67863532433E+01 -1.67863483410E+01 -1.67863433598E+01 -1.67863382983E+01 -1.67863331553E+01 -1.67863279295E+01 -1.67863226194E+01 -1.67863172239E+01 -1.67863117414E+01 -1.67863061706E+01 -1.67863005101E+01 -1.67862947584E+01 -1.67862889141E+01 -1.67862829757E+01 -1.67862769416E+01 -1.67862708103E+01 -1.67862645803E+01 -1.67862582500E+01 -1.67862518177E+01 -1.67862452819E+01 -1.67862386408E+01 -1.67862318927E+01 -1.67862250360E+01 -1.67862180689E+01 -1.67862109896E+01 -1.67862037963E+01 -1.67861964873E+01 -1.67861890605E+01 -1.67861815142E+01 -1.67861738464E+01 -1.67861660551E+01 -1.67861581384E+01 -1.67861500943E+01 -1.67861419207E+01 -1.67861336155E+01 -1.67861251766E+01 -1.67861166019E+01 -1.67861078892E+01 -1.67860990363E+01 -1.67860900409E+01 -1.67860809007E+01 -1.67860716135E+01 -1.67860621768E+01 -1.67860525882E+01 -1.67860428453E+01 -1.67860329457E+01 -1.67860228868E+01 -1.67860126660E+01 -1.67860022809E+01 -1.67859917286E+01 -1.67859810066E+01 -1.67859701121E+01 -1.67859590423E+01 -1.67859477945E+01 -1.67859363658E+01 -1.67859247532E+01 -1.67859129539E+01 -1.67859009648E+01 -1.67858887829E+01 -1.67858764052E+01 -1.67858638284E+01 -1.67858510493E+01 -1.67858380648E+01 -1.67858248715E+01 -1.67858114661E+01 -1.67857978453E+01 -1.67857840054E+01 -1.67857699431E+01 -1.67857556547E+01 -1.67857411367E+01 -1.67857263854E+01 -1.67857113970E+01 -1.67856961677E+01 -1.67856806938E+01 -1.67856649711E+01 -1.67856489959E+01 -1.67856327640E+01 -1.67856162713E+01 -1.67855995137E+01 -1.67855824869E+01 -1.67855651867E+01 -1.67855476086E+01 -1.67855297481E+01 -1.67855116009E+01 -1.67854931622E+01 -1.67854744275E+01 -1.67854553920E+01 -1.67854360509E+01 -1.67854163994E+01 -1.67853964323E+01 -1.67853761448E+01 -1.67853555317E+01 -1.67853345878E+01 -1.67853133078E+01 -1.67852916864E+01 -1.67852697181E+01 -1.67852473973E+01 -1.67852247185E+01 -1.67852016759E+01 -1.67851782638E+01 -1.67851544761E+01 -1.67851303071E+01 -1.67851057505E+01 -1.67850808002E+01 -1.67850554499E+01 -1.67850296933E+01 -1.67850035238E+01 -1.67849769349E+01 -1.67849499200E+01 -1.67849224722E+01 -1.67848945846E+01 -1.67848662503E+01 -1.67848374621E+01 -1.67848082129E+01 -1.67847784952E+01 -1.67847483017E+01 -1.67847176248E+01 -1.67846864567E+01 -1.67846547898E+01 -1.67846226160E+01 -1.67845899274E+01 -1.67845567157E+01 -1.67845229726E+01 -1.67844886898E+01 -1.67844538586E+01 -1.67844184703E+01 -1.67843825162E+01 -1.67843459873E+01 -1.67843088744E+01 -1.67842711682E+01 -1.67842328595E+01 -1.67841939386E+01 -1.67841543959E+01 -1.67841142216E+01 -1.67840734055E+01 -1.67840319377E+01 -1.67839898077E+01 -1.67839470051E+01 -1.67839035194E+01 -1.67838593396E+01 -1.67838144549E+01 -1.67837688541E+01 -1.67837225259E+01 -1.67836754589E+01 -1.67836276414E+01 -1.67835790615E+01 -1.67835297073E+01 -1.67834795666E+01 -1.67834286270E+01 -1.67833768759E+01 -1.67833243005E+01 -1.67832708879E+01 -1.67832166249E+01 -1.67831614982E+01 -1.67831054942E+01 -1.67830485991E+01 -1.67829907990E+01 -1.67829320796E+01 -1.67828724265E+01 -1.67828118252E+01 -1.67827502607E+01 -1.67826877180E+01 -1.67826241817E+01 -1.67825596364E+01 -1.67824940662E+01 -1.67824274552E+01 -1.67823597870E+01 -1.67822910452E+01 -1.67822212130E+01 -1.67821502735E+01 -1.67820782093E+01 -1.67820050029E+01 -1.67819306366E+01 -1.67818550923E+01 -1.67817783517E+01 -1.67817003962E+01 -1.67816212069E+01 -1.67815407647E+01 -1.67814590501E+01 -1.67813760434E+01 -1.67812917246E+01 -1.67812060734E+01 -1.67811190691E+01 -1.67810306908E+01 -1.67809409173E+01 -1.67808497271E+01 -1.67807570982E+01 -1.67806630084E+01 -1.67805674353E+01 -1.67804703561E+01 -1.67803717474E+01 -1.67802715859E+01 -1.67801698476E+01 -1.67800665084E+01 -1.67799615436E+01 -1.67798549283E+01 -1.67797466373E+01 -1.67796366449E+01 -1.67795249250E+01 -1.67794114513E+01 -1.67792961971E+01 -1.67791791350E+01 -1.67790602376E+01 -1.67789394769E+01 -1.67788168246E+01 -1.67786922519E+01 -1.67785657296E+01 -1.67784372281E+01 -1.67783067175E+01 -1.67781741673E+01 -1.67780395467E+01 -1.67779028243E+01 -1.67777639684E+01 -1.67776229468E+01 -1.67774797269E+01 -1.67773342757E+01 -1.67771865594E+01 -1.67770365442E+01 -1.67768841955E+01 -1.67767294784E+01 -1.67765723573E+01 -1.67764127964E+01 -1.67762507592E+01 -1.67760862087E+01 -1.67759191075E+01 -1.67757494177E+01 -1.67755771007E+01 -1.67754021175E+01 -1.67752244287E+01 -1.67750439942E+01 -1.67748607733E+01 -1.67746747248E+01 -1.67744858072E+01 -1.67742939781E+01 -1.67740991948E+01 -1.67739014137E+01 -1.67737005910E+01 -1.67734966821E+01 -1.67732896419E+01 -1.67730794246E+01 -1.67728659839E+01 -1.67726492729E+01 -1.67724292440E+01 -1.67722058492E+01 -1.67719790396E+01 -1.67717487658E+01 -1.67715149778E+01 -1.67712776249E+01 -1.67710366559E+01 -1.67707920187E+01 -1.67705436607E+01 -1.67702915286E+01 -1.67700355686E+01 -1.67697757259E+01 -1.67695119453E+01 -1.67692441708E+01 -1.67689723457E+01 -1.67686964126E+01 -1.67684163135E+01 -1.67681319897E+01 -1.67678433816E+01 -1.67675504290E+01 -1.67672530709E+01 -1.67669512459E+01 -1.67666448914E+01 -1.67663339443E+01 -1.67660183408E+01 -1.67656980163E+01 -1.67653729054E+01 -1.67650429419E+01 -1.67647080590E+01 -1.67643681891E+01 -1.67640232636E+01 -1.67636732135E+01 -1.67633179687E+01 -1.67629574584E+01 -1.67625916110E+01 -1.67622203543E+01 -1.67618436151E+01 -1.67614613193E+01 -1.67610733923E+01 -1.67606797584E+01 -1.67602803412E+01 -1.67598750636E+01 -1.67594638474E+01 -1.67590466139E+01 -1.67586232832E+01 -1.67581937750E+01 -1.67577580077E+01 -1.67573158993E+01 -1.67568673665E+01 -1.67564123256E+01 -1.67559506918E+01 -1.67554823795E+01 -1.67550073022E+01 -1.67545253725E+01 -1.67540365024E+01 -1.67535406027E+01 -1.67530375836E+01 -1.67525273543E+01 -1.67520098231E+01 -1.67514848974E+01 -1.67509524840E+01 -1.67504124886E+01 -1.67498648159E+01 -1.67493093699E+01 -1.67487460539E+01 -1.67481747698E+01 -1.67475954192E+01 -1.67470079024E+01 -1.67464121189E+01 -1.67458079675E+01 -1.67451953460E+01 -1.67445741511E+01 -1.67439442789E+01 -1.67433056246E+01 -1.67426580822E+01 -1.67420015452E+01 -1.67413359060E+01 -1.67406610560E+01 -1.67399768860E+01 -1.67392832857E+01 -1.67385801438E+01 -1.67378673484E+01 -1.67371447865E+01 -1.67364123442E+01 -1.67356699067E+01 -1.67349173585E+01 -1.67341545829E+01 -1.67333814624E+01 -1.67325978786E+01 -1.67318037124E+01 -1.67309988434E+01 -1.67301831506E+01 -1.67293565120E+01 -1.67285188045E+01 -1.67276699044E+01 -1.67268096868E+01 -1.67259380260E+01 -1.67250547955E+01 -1.67241598676E+01 -1.67232531138E+01 -1.67223344047E+01 -1.67214036099E+01 -1.67204605981E+01 -1.67195052369E+01 -1.67185373932E+01 -1.67175569326E+01 -1.67165637200E+01 -1.67155576191E+01 -1.67145384929E+01 -1.67135062031E+01 -1.67124606105E+01 -1.67114015749E+01 -1.67103289551E+01 -1.67092426088E+01 -1.67081423926E+01 -1.67070281622E+01 -1.67058997719E+01 -1.67047570752E+01 -1.67035999244E+01 -1.67024281706E+01 -1.67012416638E+01 -1.67000402527E+01 -1.66988237851E+01 -1.66975921072E+01 -1.66963450643E+01 -1.66950825002E+01 -1.66938042574E+01 -1.66925101774E+01 -1.66912000999E+01 -1.66898738635E+01 -1.66885313053E+01 -1.66871722610E+01 -1.66857965647E+01 -1.66844040491E+01 -1.66829945452E+01 -1.66815678826E+01 -1.66801238889E+01 -1.66786623905E+01 -1.66771832115E+01 -1.66756861746E+01 -1.66741711005E+01 -1.66726378080E+01 -1.66710861139E+01 -1.66695158330E+01 -1.66679267781E+01 -1.66663187597E+01 -1.66646915861E+01 -1.66630450633E+01 -1.66613789950E+01 -1.66596931824E+01 -1.66579874241E+01 -1.66562615161E+01 -1.66545152518E+01 -1.66527484215E+01 -1.66509608131E+01 -1.66491522109E+01 -1.66473223966E+01 -1.66454711484E+01 -1.66435982412E+01 -1.66417034465E+01 -1.66397865323E+01 -1.66378472628E+01 -1.66358853984E+01 -1.66339006955E+01 -1.66318929067E+01 -1.66298617798E+01 -1.66278070588E+01 -1.66257284827E+01 -1.66236257860E+01 -1.66214986983E+01 -1.66193469442E+01 -1.66171702429E+01 -1.66149683083E+01 -1.66127408488E+01 -1.66104875668E+01 -1.66082081587E+01 -1.66059023149E+01 -1.66035697191E+01 -1.66012100485E+01 -1.65988229734E+01 -1.65964081569E+01 -1.65939652546E+01 -1.65914939148E+01 -1.65889937775E+01 -1.65864644748E+01 -1.65839056302E+01 -1.65813168585E+01 -1.65786977654E+01 -1.65760479474E+01 -1.65733669911E+01 -1.65706544732E+01 -1.65679099600E+01 -1.65651330073E+01 -1.65623231595E+01 -1.65594799500E+01 -1.65566028999E+01 -1.65536915186E+01 -1.65507453025E+01 -1.65477637353E+01 -1.65447462870E+01 -1.65416924139E+01 -1.65386015577E+01 -1.65354731457E+01 -1.65323065896E+01 -1.65291012854E+01 -1.65258566128E+01 -1.65225719347E+01 -1.65192465967E+01 -1.65158799264E+01 -1.65124712330E+01 -1.65090198067E+01 -1.65055249178E+01 -1.65019858167E+01 -1.64984017327E+01 -1.64947718735E+01 -1.64910954246E+01 -1.64873715488E+01 -1.64835993849E+01 -1.64797780478E+01 -1.64759066270E+01 -1.64719841864E+01 -1.64680097630E+01 -1.64639823667E+01 -1.64599009790E+01 -1.64557645522E+01 -1.64515720089E+01 -1.64473222407E+01 -1.64430141074E+01 -1.64386464362E+01 -1.64342180208E+01 -1.64297276200E+01 -1.64251739571E+01 -1.64205557188E+01 -1.64158715542E+01 -1.64111200733E+01 -1.64062998464E+01 -1.64014094028E+01 -1.63964472297E+01 -1.63914117707E+01 -1.63863014251E+01 -1.63811145462E+01 -1.63758494403E+01 -1.63705043654E+01 -1.63650775298E+01 -1.63595670905E+01 -1.63539711526E+01 -1.63482877668E+01 -1.63425149290E+01 -1.63366505781E+01 -1.63306925949E+01 -1.63246388002E+01 -1.63184869539E+01 -1.63122347526E+01 -1.63058798285E+01 -1.62994197477E+01 -1.62928520083E+01 -1.62861740390E+01 -1.62793831969E+01 -1.62724767663E+01 -1.62654519566E+01 -1.62583059001E+01 -1.62510356510E+01 -1.62436381828E+01 -1.62361103865E+01 -1.62284490689E+01 -1.62206509506E+01 -1.62127126636E+01 -1.62046307497E+01 -1.61964016584E+01 -1.61880217445E+01 -1.61794872663E+01 -1.61707943835E+01 -1.61619391549E+01 -1.61529175363E+01 -1.61437253781E+01 -1.61343584235E+01 -1.61248123061E+01 -1.61150825476E+01 -1.61051645556E+01 -1.60950536213E+01 -1.60847449175E+01 -1.60742334959E+01 -1.60635142854E+01 -1.60525820892E+01 -1.60414315830E+01 -1.60300573128E+01 -1.60184536922E+01 -1.60066150005E+01 -1.59945353807E+01 -1.59822088367E+01 -1.59696292319E+01 -1.59567902863E+01 -1.59436855750E+01 -1.59303085261E+01 -1.59166524182E+01 -1.59027103791E+01 -1.58884753835E+01 -1.58739402512E+01 -1.58590976455E+01 -1.58439400717E+01 -1.58284598748E+01 -1.58126492391E+01 -1.57965001855E+01 -1.57800045716E+01 -1.57631540893E+01 -1.57459402647E+01 -1.57283544567E+01 -1.57103878563E+01 -1.56920314864E+01 -1.56732762006E+01 -1.56541126840E+01 -1.56345314523E+01 -1.56145228523E+01 -1.55940770625E+01 -1.55731840932E+01 -1.55518337879E+01 -1.55300158240E+01 -1.55077197146E+01 -1.54849348099E+01 -1.54616502992E+01 -1.54378552134E+01 -1.54135384275E+01 -1.53886886639E+01 -1.53632944954E+01 -1.53373443492E+01 -1.53108265112E+01 -1.52837291304E+01 -1.52560402244E+01 -1.52277476843E+01 -1.51988392814E+01 -1.51693026735E+01 -1.51391254120E+01 -1.51082949496E+01 -1.50767986486E+01 -1.50446237895E+01 -1.50117575810E+01 -1.49781871696E+01 -1.49438996508E+01 -1.49088820801E+01 -1.48731214860E+01 -1.48366048822E+01 -1.47993192817E+01 -1.47612517114E+01 -1.47223892272E+01 -1.46827189306E+01 -1.46422279852E+01 -1.46009036349E+01 -1.45587332230E+01 -1.45157042116E+01 -1.44718042023E+01 -1.44270209582E+01 -1.43813424264E+01 -1.43347567617E+01 -1.42872523513E+01 -1.42388178404E+01 -1.41894421593E+01 -1.41391145510E+01 -1.40878246002E+01 -1.40355622635E+01 -1.39823179002E+01 -1.39280823044E+01 -1.38728467386E+01 -1.38166029681E+01 -1.37593432959E+01 -1.37010605996E+01 -1.36417483689E+01 -1.35814007441E+01 -1.35200125556E+01 -1.34575793647E+01 -1.33940975048E+01 -1.33295641242E+01 -1.32639772290E+01 -1.31973357276E+01 -1.31296394752E+01 -1.30608893197E+01 -1.29910871476E+01 -1.29202359310E+01 -1.28483397746E+01 -1.27754039634E+01 -1.27014350106E+01 -1.26264407052E+01 -1.25504301604E+01 -1.24734138614E+01 -1.23954037126E+01 -1.23164130855E+01 -1.22364568645E+01 -1.21555514933E+01 -1.20737150195E+01 -1.19909671381E+01 -1.19073292339E+01 -1.18228244220E+01 -1.17374775864E+01 -1.16513154163E+01 -1.15643664401E+01 -1.14766610568E+01 -1.13882315632E+01 -1.12991121791E+01 -1.12093390674E+01 -1.11189503507E+01 -1.10279861225E+01 -1.09364884540E+01 -1.08445013948E+01 -1.07520709678E+01 -1.06592451570E+01 -1.05660738889E+01 -1.04726090055E+01 -1.03789042294E+01 -1.02850151197E+01 -1.01909990185E+01 -1.00969149872E+01 -1.00028237318E+01 -9.90878751610E+00 -9.81487006356E+00 -9.72113644496E+00 -9.62765295273E+00 -9.53448696043E+00 -9.44170676675E+00 -9.34938142329E+00 -9.25758054526E+00 -9.16637410441E+00 -9.07583220339E+00 -8.98602483091E+00 -8.89702159700E+00 -8.80889144785E+00 -8.72170235969E+00 -8.63552101144E+00 -8.55041243576E+00 -8.46643964862E+00 -8.38366325739E+00 -8.30214104797E+00 -8.22192755160E+00 -8.14307359239E+00 -8.06562581701E+00 -7.98962620850E+00 -7.91511158664E+00 -7.84211309790E+00 -7.77065569891E+00 -7.70075763790E+00 -7.63242993991E+00 -7.56567590211E+00 -7.50049060733E+00 -7.43686046480E+00 -7.37476278893E+00 -7.31416542851E+00 -7.25502646062E+00 -7.19729396583E+00 -7.14090590358E+00 -7.08579010903E+00 -7.03186443620E+00 -6.97903707473E+00 -6.92720707197E+00 -6.87626509532E+00 -6.82609447497E+00 -6.77657257121E+00 -6.72757251662E+00 -6.67896538881E+00 -6.63062287623E+00 -6.58242050677E+00 -6.53424151674E+00 -6.48598144676E+00 -6.43755356097E+00 -6.38889519665E+00 -6.33997516350E+00 -6.29080232524E+00 -6.24143551080E+00 -6.19199491891E+00 -6.14267519803E+00 -6.09369980985E+00 -6.04511714515E+00 -5.99692388465E+00 -5.94911674874E+00 -5.90169249634E+00 -5.85464792388E+00 -5.80797986414E+00 -5.76168518542E+00 -5.71576079056E+00 -5.67020361575E+00 -5.62501063005E+00 -5.58017883445E+00 -5.53570526110E+00 -5.49158697255E+00 -5.44782106104E+00 -5.40440464787E+00 -5.36133488274E+00 -5.31860894311E+00 -5.27622403367E+00 -5.23417738578E+00 -5.19246625690E+00 -5.15108793013E+00 -5.11003971372E+00 -5.06931894060E+00 -5.02892296795E+00 -4.98884917678E+00 -4.94909497155E+00 -4.90965777974E+00 -4.87053505154E+00 -4.83172425946E+00 -4.79322289800E+00 -4.75502848335E+00 -4.71713855305E+00 -4.67955066573E+00 -4.64226240078E+00 -4.60527135811E+00 -4.56857515787E+00 -4.53217144020E+00 -4.49605786499E+00 -4.46023211162E+00 -4.42469187877E+00 -4.38943488417E+00 -4.35445886437E+00 -4.31976157458E+00 -4.28534078844E+00 -4.25119429781E+00 -4.21731991260E+00 -4.18371546060E+00 -4.15037931965E+00 -4.11730882097E+00 -4.08450184534E+00 -4.05195629072E+00 -4.01967007204E+00 -3.98764112108E+00 -3.95586738632E+00 -3.92434683276E+00 -3.89307745156E+00 -3.86205723063E+00 -3.83128418368E+00 -3.80075634037E+00 -3.77047174616E+00 -3.74042846218E+00 -3.71062456509E+00 -3.68105814698E+00 -3.65172731517E+00 -3.62263019214E+00 -3.59376491539E+00 -3.56512963730E+00 -3.53672252501E+00 -3.50854176031E+00 -3.48058553951E+00 -3.45285207330E+00 -3.42533958668E+00 -3.39804631880E+00 -3.37097052287E+00 -3.34411046602E+00 -3.31746442921E+00 -3.29103070710E+00 -3.26480760798E+00 -3.23879345359E+00 -3.21298657906E+00 -3.18738533281E+00 -3.16198807641E+00 -3.13679318449E+00 -3.11179904464E+00 -3.08700405730E+00 -3.06240663564E+00 -3.03800520550E+00 -3.01379820525E+00 -2.98978408572E+00 -2.96596131006E+00 -2.94232835368E+00 -2.91888370414E+00 -2.89562586104E+00 -2.87255333595E+00 -2.84966465229E+00 -2.82695834524E+00 -2.80443296167E+00 -2.78208706000E+00 -2.75991921015E+00 -2.73792799345E+00 -2.71611200250E+00 -2.69446984115E+00 -2.67300012433E+00 -2.65170147805E+00 -2.63057253925E+00 -2.60961195571E+00 -2.58881838600E+00 -2.56819049940E+00 -2.54772697576E+00 -2.52742650546E+00 -2.50728778931E+00 -2.48730953848E+00 -2.46749047441E+00 -2.44782932871E+00 -2.42832484311E+00 -2.40897576937E+00 -2.38978086919E+00 -2.37073891413E+00 -2.35184868555E+00 -2.33310897450E+00 -2.31451858169E+00 -2.29607631737E+00 -2.27778100126E+00 -2.25963146251E+00 -2.24162653958E+00 -2.22376508019E+00 -2.20604594124E+00 -2.18846798874E+00 -2.17103009774E+00 -2.15373115224E+00 -2.13657004515E+00 -2.11954567819E+00 -2.10265696184E+00 -2.08590281524E+00 -2.06928216617E+00 -2.05279395094E+00 -2.03643711433E+00 -2.02021060954E+00 -2.00411339810E+00 -1.98814444982E+00 -1.97230274273E+00 -1.95658726297E+00 -1.94099700480E+00 -1.92553097046E+00 -1.91018817016E+00 -1.89496762199E+00 -1.87986835186E+00 -1.86488939344E+00 -1.85002978811E+00 -1.83528858489E+00 -1.82066484036E+00 -1.80615761863E+00 -1.79176599127E+00 -1.77748903722E+00 -1.76332584280E+00 -1.74927550159E+00 -1.73533711438E+00 -1.72150978914E+00 -1.70779264095E+00 -1.69418479192E+00 -1.68068537118E+00 -1.66729351479E+00 -1.65400836568E+00 -1.64082907363E+00 -1.62775479517E+00 -1.61478469358E+00 -1.60191793878E+00 -1.58915370731E+00 -1.57649118228E+00 -1.56392955331E+00 -1.55146801646E+00 -1.53910577420E+00 -1.52684203537E+00 -1.51467601509E+00 -1.50260693476E+00 -1.49063402195E+00 -1.47875651042E+00 -1.46697364001E+00 -1.45528465662E+00 -1.44368881217E+00 -1.43218536452E+00 -1.42077357747E+00 -1.40945272065E+00 -1.39822206955E+00 -1.38708090539E+00 -1.37602851516E+00 -1.36506419149E+00 -1.35418723268E+00 -1.34339694259E+00 -1.33269263065E+00 -1.32207361178E+00 -1.31153920636E+00 -1.30108874020E+00 -1.29072154444E+00 -1.28043695560E+00 -1.27023431545E+00 -1.26011297103E+00 -1.25007227455E+00 -1.24011158342E+00 -1.23023026014E+00 -1.22042767230E+00 -1.21070319253E+00 -1.20105619845E+00 -1.19148607266E+00 -1.18199220265E+00 -1.17257398082E+00 -1.16323080439E+00 -1.15396207538E+00 -1.14476720059E+00 -1.13564559154E+00 -1.12659666444E+00 -1.11761984016E+00 -1.10871454415E+00 -1.09988020648E+00 -1.09111626175E+00 -1.08242214904E+00 -1.07379731193E+00 -1.06524119842E+00 -1.05675326091E+00 -1.04833295616E+00 -1.03997974526E+00 -1.03169309361E+00 -1.02347247084E+00 -1.01531735083E+00 -1.00722721164E+00 -9.99201535495E-01 -9.91239808743E-01 -9.83341521824E-01 -9.75506169242E-01 -9.67733249524E-01 -9.60022265198E-01 -9.52372722752E-01 -9.44784132608E-01 -9.37256009089E-01 -9.29787870389E-01 -9.22379238539E-01 -9.15029639380E-01 -9.07738602532E-01 -9.00505661360E-01 -8.93330352952E-01 -8.86212218081E-01 -8.79150801180E-01 -8.72145650314E-01 -8.65196317146E-01 -8.58302356915E-01 -8.51463328401E-01 -8.44678793901E-01 -8.37948319201E-01 -8.31271473545E-01 -8.24647829610E-01 -8.18076963479E-01 -8.11558454612E-01 -8.05091885820E-01 -7.98676843239E-01 -7.92312916302E-01 -7.85999697713E-01 -7.79736783424E-01 -7.73523772604E-01 -7.67360267616E-01 -7.61245873994E-01 -7.55180200413E-01 -7.49162858666E-01 -7.43193463641E-01 -7.37271633294E-01 -7.31396988623E-01 -7.25569153650E-01 -7.19787755390E-01 -7.14052423831E-01 -7.08362791909E-01 -7.02718495486E-01 -6.97119173323E-01 -6.91564467062E-01 -6.86054021199E-01 -6.80587483063E-01 -6.75164502794E-01 -6.69784733318E-01 -6.64447830329E-01 -6.59153459681E-01 -6.53901267269E-01 -6.48690924814E-01 -6.43522098851E-01 -6.38394458573E-01 -6.33307675808E-01 -6.28261424999E-01 -6.23255383183E-01 -6.18289229971E-01 -6.13362647527E-01 -6.08475320547E-01 -6.03626936239E-01 -5.98817184304E-01 -5.94045790778E-01 -5.89312380761E-01 -5.84616687059E-01 -5.79958409143E-01 -5.75337248877E-01 -5.70752910502E-01 -5.66204758502E-01 -5.61693482206E-01 -5.57217860696E-01 -5.52777901321E-01 -5.48373319920E-01 -5.44003834598E-01 -5.39669165708E-01 -5.35369035829E-01 -5.31103169752E-01 -5.26871294458E-01 -5.22673139108E-01 -5.18508435017E-01 -5.14376915643E-01 -5.10278316567E-01 -5.06212375478E-01 -5.02178832155E-01 -4.98177428448E-01 -4.94207908266E-01 -4.90270017560E-01 -4.86363504302E-01 -4.82488118475E-01 -4.78643612052E-01 -4.74829738984E-01 -4.71046255181E-01 -4.67292918500E-01 -4.63569488725E-01 -4.59875727556E-01 -4.56211398590E-01 -4.52576267310E-01 -4.48970101066E-01 -4.45392669061E-01 -4.41843742339E-01 -4.38323093768E-01 -4.34830498025E-01 -4.31365731582E-01 -4.27928572693E-01 -4.24518801380E-01 -4.21136199414E-01 -4.17780550309E-01 -4.14451639302E-01 -4.11149253342E-01 -4.07873181074E-01 -4.04623212829E-01 -4.01399140608E-01 -3.98200758069E-01 -3.95027860515E-01 -3.91880244878E-01 -3.88757709712E-01 -3.85660055171E-01 -3.82587083006E-01 -3.79538596544E-01 -3.76514400683E-01 -3.73514301871E-01 -3.70538108103E-01 -3.67585628900E-01 -3.64656675303E-01 -3.61751059857E-01 -3.58868596603E-01 -3.56009101062E-01 -3.53172390225E-01 -3.50358282520E-01 -3.47566597887E-01 -3.44797157635E-01 -3.42049784519E-01 -3.39324302706E-01 -3.36620537764E-01 -3.33938316652E-01 -3.31277467706E-01 -3.28637820630E-01 -3.26019206488E-01 -3.23421457686E-01 -3.20844407967E-01 -3.18287892401E-01 -3.15751747368E-01 -3.13235810554E-01 -3.10739920940E-01 -3.08263918786E-01 -3.05807645629E-01 -3.03370944265E-01 -3.00953658745E-01 -2.98555634362E-01 -2.96176717641E-01 -2.93816756332E-01 -2.91475599395E-01 -2.89153096996E-01 -2.86849100494E-01 -2.84563462433E-01 -2.82296036530E-01 -2.80046677670E-01 -2.77815241892E-01 -2.75601586385E-01 -2.73405569474E-01 -2.71227050612E-01 -2.69065890375E-01 -2.66921950446E-01 -2.64795093613E-01 -2.62685183756E-01 -2.60592085841E-01 -2.58515665908E-01 -2.56455791066E-01 -2.54412329482E-01 -2.52385150375E-01 -2.50374124003E-01 -2.48379121660E-01 -2.46400015666E-01 -2.44436679357E-01 -2.42488987079E-01 -2.40556814179E-01 -2.38640036997E-01 -2.36738532859E-01 -2.34852180067E-01 -2.32980857896E-01 -2.31124446579E-01 -2.29282827305E-01 -2.27455882211E-01 -2.25643494371E-01 -2.23845547791E-01 -2.22061927403E-01 -2.20292519054E-01 -2.18537209501E-01 -2.16795886405E-01 -2.15068438319E-01 -2.13354754687E-01 -2.11654725831E-01 -2.09968242951E-01 -2.08295198109E-01 -2.06635484232E-01 -2.04988995096E-01 -2.03355625325E-01 -2.01735270384E-01 -2.00127826570E-01 -1.98533191004E-01 -1.96951261631E-01 -1.95381937205E-01 -1.93825117290E-01 -1.92280702249E-01 -1.90748593238E-01 -1.89228692202E-01 -1.87720901868E-01 -1.86225125735E-01 -1.84741268073E-01 -1.83269233916E-01 -1.81808929053E-01 -1.80360260023E-01 -1.78923134111E-01 -1.77497459340E-01 -1.76083144468E-01 -1.74680098977E-01 -1.73288233072E-01 -1.71907457674E-01 -1.70537684411E-01 -1.69178825618E-01 -1.67830794328E-01 -1.66493504265E-01 -1.65166869844E-01 -1.63850806159E-01 -1.62545228982E-01 -1.61250054754E-01 -1.59965200586E-01 -1.58690584244E-01 -1.57426124154E-01 -1.56171739390E-01 -1.54927349671E-01 -1.53692875355E-01 -1.52468237435E-01 -1.51253357534E-01 -1.50048157900E-01 -1.48852561400E-01 -1.47666491514E-01 -1.46489872333E-01 -1.45322628555E-01 -1.44164685475E-01 -1.43015968983E-01 -1.41876405563E-01 -1.40745922281E-01 -1.39624446786E-01 -1.38511907303E-01 -1.37408232629E-01 -1.36313352130E-01 -1.35227195731E-01 -1.34149693919E-01 -1.33080777733E-01 -1.32020378763E-01 -1.30968429142E-01 -1.29924861545E-01 -1.28889609183E-01 -1.27862605801E-01 -1.26843785668E-01 -1.25833083582E-01 -1.24830434855E-01 -1.23835775320E-01 -1.22849041316E-01 -1.21870169692E-01 -1.20899097801E-01 -1.19935763494E-01 -1.18980105116E-01 -1.18032061506E-01 -1.17091571988E-01 -1.16158576371E-01 -1.15233014942E-01 -1.14314828465E-01 -1.13403958176E-01 -1.12500345780E-01 -1.11603933444E-01 -1.10714663798E-01 -1.09832479928E-01 -1.08957325374E-01 -1.08089144126E-01 -1.07227880621E-01 -1.06373479736E-01 -1.05525886790E-01 -1.04685047538E-01 -1.03850908163E-01 -1.03023415283E-01 -1.02202515936E-01 -1.01388157585E-01 -1.00580288111E-01 -9.97788558099E-02 -9.89838093893E-02 -9.81950979663E-02 -9.74126710632E-02 -9.66364786042E-02 -9.58664709128E-02 -9.51025987083E-02 -9.43448131026E-02 -9.35930655971E-02 -9.28473080798E-02 -9.21074928218E-02 -9.13735724749E-02 -9.06455000678E-02 -8.99232290036E-02 -8.92067130568E-02 -8.84959063700E-02 -8.77907634515E-02 -8.70912391718E-02 -8.63972887611E-02 -8.57088678064E-02 -8.50259322485E-02 -8.43484383793E-02 -8.36763428389E-02 -8.30096026131E-02 -8.23481750301E-02 -8.16920177585E-02 -8.10410888038E-02 -8.03953465065E-02 1 0 Beta L 919 7.45279957066E-02 7.51266049116E-02 7.57300220504E-02 7.63382857372E-02 7.69520301845E-02 7.75666407036E-02 7.81937120026E-02 7.88163097668E-02 7.94544829322E-02 8.00900337796E-02 8.07341368900E-02 8.13844319183E-02 8.20377515024E-02 8.26982788017E-02 8.33575610770E-02 8.40292441842E-02 8.47077163790E-02 8.53848016355E-02 8.60746050591E-02 8.67617887208E-02 8.74592460211E-02 8.81620937478E-02 8.88682307021E-02 8.95870852779E-02 9.03049918810E-02 9.10266349608E-02 9.17605799074E-02 9.24950615537E-02 9.32423960495E-02 9.39882786728E-02 9.47411027983E-02 9.55050397540E-02 9.62698011671E-02 9.70431117435E-02 9.78277292648E-02 9.86079427241E-02 9.94012209041E-02 1.00201168141E-01 1.01003154653E-01 1.01818474593E-01 1.02636853661E-01 1.03456086820E-01 1.04290962576E-01 1.05122697205E-01 1.05974826648E-01 1.06823892211E-01 1.07679883247E-01 1.08546624516E-01 1.09417867112E-01 1.10295208141E-01 1.11184681159E-01 1.12077463631E-01 1.12973941800E-01 1.13881803217E-01 1.14796139280E-01 1.15718529254E-01 1.16648605726E-01 1.17585377700E-01 1.18530689278E-01 1.19482930247E-01 1.20442337994E-01 1.21409804340E-01 1.22385812241E-01 1.23368332601E-01 1.24359279108E-01 1.25357413333E-01 1.26365158563E-01 1.27378359303E-01 1.28403463056E-01 1.29435654907E-01 1.30472490110E-01 1.31520973897E-01 1.32576057996E-01 1.33640551198E-01 1.34716346209E-01 1.35796912720E-01 1.36887615435E-01 1.37988671815E-01 1.39095681318E-01 1.40214877854E-01 1.41339681886E-01 1.42473578779E-01 1.43620161174E-01 1.44772894500E-01 1.45933045256E-01 1.47108539757E-01 1.48288526037E-01 1.49481188774E-01 1.50679629559E-01 1.51892471955E-01 1.53109979890E-01 1.54340758340E-01 1.55578084410E-01 1.56831236768E-01 1.58086716461E-01 1.59358247793E-01 1.60639205336E-01 1.61929727590E-01 1.63229350084E-01 1.64538778871E-01 1.65861725701E-01 1.67194107324E-01 1.68539027532E-01 1.69890893318E-01 1.71254474164E-01 1.72630096542E-01 1.74015643095E-01 1.75415586396E-01 1.76822801297E-01 1.78242871366E-01 1.79676714612E-01 1.81116567668E-01 1.82574022742E-01 1.84039289038E-01 1.85518481806E-01 1.87006387288E-01 1.88510985248E-01 1.90022258424E-01 1.91551242671E-01 1.93088243200E-01 1.94638742794E-01 1.96202999363E-01 1.97778375025E-01 1.99367019778E-01 2.00968128943E-01 2.02581945124E-01 2.04209204462E-01 2.05848240180E-01 2.07503300128E-01 2.09169307072E-01 2.10849674661E-01 2.12542818860E-01 2.14248977913E-01 2.15970292840E-01 2.17705183961E-01 2.19453387558E-01 2.21215312918E-01 2.22992459497E-01 2.24783189259E-01 2.26588114710E-01 2.28408527705E-01 2.30242605056E-01 2.32092235850E-01 2.33955751992E-01 2.35835654348E-01 2.37729150795E-01 2.39637981483E-01 2.41564214471E-01 2.43504478547E-01 2.45458110863E-01 2.47430932062E-01 2.49418144381E-01 2.51419027371E-01 2.53439469198E-01 2.55473099480E-01 2.57527077391E-01 2.59594123575E-01 2.61680042412E-01 2.63781554325E-01 2.65899514383E-01 2.68036565040E-01 2.70187829447E-01 2.72357644302E-01 2.74544097646E-01 2.76750199681E-01 2.78972286708E-01 2.81213784837E-01 2.83471492603E-01 2.85748594243E-01 2.88042709476E-01 2.90357229886E-01 2.92687463784E-01 2.95039853249E-01 2.97408304421E-01 2.99796459462E-01 3.02204416367E-01 3.04630118794E-01 3.07077655905E-01 3.09544718568E-01 3.12028564742E-01 3.14536220670E-01 3.17061890742E-01 3.19607641596E-01 3.22173920295E-01 3.24761364990E-01 3.27369951585E-01 3.29998103005E-01 3.32649333107E-01 3.35318775960E-01 3.38013716586E-01 3.40727557966E-01 3.43463804508E-01 3.46221679897E-01 3.49001929953E-01 3.51804292105E-01 3.54629887718E-01 3.57477470144E-01 3.60347697706E-01 3.63242043902E-01 3.66159453461E-01 3.69098647604E-01 3.72062944686E-01 3.75051017009E-01 3.78062442438E-01 3.81098402511E-01 3.84157944641E-01 3.87244005091E-01 3.90352822935E-01 3.93487756629E-01 3.96646724924E-01 3.99831750694E-01 4.03042255694E-01 4.06279584695E-01 4.09541052147E-01 4.12829913341E-01 4.16144882360E-01 4.19486545946E-01 4.22854498670E-01 4.26250280354E-01 4.29672834509E-01 4.33123025941E-01 4.36600500354E-01 4.40107438801E-01 4.43639673151E-01 4.47202073985E-01 4.50792510958E-01 4.54412378556E-01 4.58061447646E-01 4.61739009631E-01 4.65446492106E-01 4.69184157224E-01 4.72951312475E-01 4.76747687253E-01 4.80575391080E-01 4.84434132140E-01 4.88324094709E-01 4.92244569976E-01 4.96197153645E-01 5.00179973040E-01 5.04196313122E-01 5.08243845367E-01 5.12324702648E-01 5.16438137622E-01 5.20584235753E-01 5.24763340109E-01 5.28976887954E-01 5.33223207176E-01 5.37504252619E-01 5.41819169419E-01 5.46169083182E-01 5.50553327392E-01 5.54973241225E-01 5.59428541601E-01 5.63919685804E-01 5.68447341995E-01 5.73009626576E-01 5.77609180873E-01 5.82246677100E-01 5.86920420293E-01 5.91632075007E-01 5.96381199684E-01 6.01168127124E-01 6.05994043427E-01 6.10858526911E-01 6.15761463112E-01 6.20704756120E-01 6.25686537267E-01 6.30709305624E-01 6.35771615839E-01 6.40874580172E-01 6.46018248895E-01 6.51203514710E-01 6.56429924563E-01 6.61698772913E-01 6.67009758760E-01 6.72363249842E-01 6.77759778748E-01 6.83198808120E-01 6.88681951121E-01 6.94209347900E-01 6.99780498495E-01 7.05396322386E-01 7.11057680401E-01 7.16763723721E-01 7.22516776814E-01 7.28313552287E-01 7.34158950948E-01 7.40050133617E-01 7.45988591496E-01 7.51975271920E-01 7.58008399159E-01 7.64091286272E-01 7.70222931898E-01 7.76402772713E-01 7.82632178025E-01 7.88912085721E-01 7.95242001007E-01 8.01622275636E-01 8.08053761239E-01 8.14537212071E-01 8.21072225603E-01 8.27659367068E-01 8.34299695069E-01 8.40992659020E-01 8.47739936505E-01 8.54540292686E-01 8.61395412169E-01 8.68305667009E-01 8.75270903694E-01 8.82292175613E-01 8.89369087645E-01 8.96502939513E-01 9.03694120866E-01 9.10942267280E-01 9.18248847274E-01 9.25613563633E-01 9.33037331134E-01 9.40520517926E-01 9.48063391114E-01 9.55666422722E-01 9.63330427934E-01 9.71055991005E-01 9.78843030325E-01 9.86692155937E-01 9.94604304077E-01 1.00257946009E+00 1.01061834704E+00 1.01872155837E+00 1.02688965966E+00 1.03512293327E+00 1.04342145776E+00 1.05178714368E+00 1.06021903746E+00 1.06871826616E+00 1.07728563477E+00 1.08592128340E+00 1.09462600776E+00 1.10340017612E+00 1.11224451195E+00 1.12115919950E+00 1.13014487360E+00 1.13920279196E+00 1.14833245664E+00 1.15753522411E+00 1.16681126576E+00 1.17616141061E+00 1.18558589114E+00 1.19508572162E+00 1.20466180232E+00 1.21431343783E+00 1.22404227875E+00 1.23384869214E+00 1.24373332435E+00 1.25369667658E+00 1.26373918721E+00 1.27386207013E+00 1.28406554899E+00 1.29434969926E+00 1.30471674796E+00 1.31516553892E+00 1.32569817161E+00 1.33631399596E+00 1.34701452677E+00 1.35780021249E+00 1.36867181712E+00 1.37962969089E+00 1.39067503334E+00 1.40180818753E+00 1.41302970710E+00 1.42434013173E+00 1.43574137618E+00 1.44723209494E+00 1.45881523457E+00 1.47048950012E+00 1.48225701026E+00 1.49411767130E+00 1.50607278871E+00 1.51812264006E+00 1.53026812257E+00 1.54251010269E+00 1.55484921652E+00 1.56728589500E+00 1.57982179251E+00 1.59245677962E+00 1.60519179226E+00 1.61802792430E+00 1.63096583975E+00 1.64400605228E+00 1.65714959899E+00 1.67039729476E+00 1.68374983448E+00 1.69720804036E+00 1.71077282568E+00 1.72444494454E+00 1.73822500442E+00 1.75211442109E+00 1.76611309542E+00 1.78022298047E+00 1.79444396475E+00 1.80877753373E+00 1.82322413742E+00 1.83778486180E+00 1.85246062244E+00 1.86725192390E+00 1.88216033058E+00 1.89718552732E+00 1.91233009733E+00 1.92759338571E+00 1.94297719790E+00 1.95848196926E+00 1.97410884769E+00 1.98985894856E+00 2.00573293944E+00 2.02173167860E+00 2.03785615203E+00 2.05410759923E+00 2.07048656452E+00 2.08699411184E+00 2.10363170632E+00 2.12039931042E+00 2.13729895117E+00 2.15433080846E+00 2.17149635151E+00 2.18879633134E+00 2.20623194635E+00 2.22380401844E+00 2.24151354887E+00 2.25936164108E+00 2.27734938615E+00 2.29547779199E+00 2.31374786449E+00 2.33216032697E+00 2.35071680987E+00 2.36941790776E+00 2.38826504669E+00 2.40725902618E+00 2.42640102468E+00 2.44569192450E+00 2.46513321225E+00 2.48472530094E+00 2.50447022939E+00 2.52436829093E+00 2.54442094205E+00 2.56462938141E+00 2.58499437276E+00 2.60551742286E+00 2.62619933060E+00 2.64704156736E+00 2.66804516438E+00 2.68921107612E+00 2.71054063966E+00 2.73203506548E+00 2.75369528127E+00 2.77552259138E+00 2.79751831725E+00 2.81968336058E+00 2.84201907305E+00 2.86452678581E+00 2.88720737003E+00 2.91006219517E+00 2.93309264807E+00 2.95629954359E+00 2.97968443166E+00 3.00324835438E+00 3.02699265490E+00 3.05091852570E+00 3.07502708375E+00 3.09931983432E+00 3.12379787474E+00 3.14846237223E+00 3.17331451806E+00 3.19835607756E+00 3.22358772734E+00 3.24901099378E+00 3.27462690577E+00 3.30043737476E+00 3.32644285589E+00 3.35264517943E+00 3.37904549750E+00 3.40564505299E+00 3.43244509977E+00 3.45944710645E+00 3.48665221422E+00 3.51406175814E+00 3.54167715980E+00 3.56949942327E+00 3.59753010628E+00 3.62577057805E+00 3.65422196993E+00 3.68288556748E+00 3.71176285907E+00 3.74085499976E+00 3.77016347121E+00 3.79968950795E+00 3.82943433911E+00 3.85939935643E+00 3.88958592857E+00 3.91999537542E+00 3.95062887732E+00 3.98148784571E+00 4.01257369281E+00 4.04388750738E+00 4.07543073901E+00 4.10720472074E+00 4.13921066685E+00 4.17145004973E+00 4.20392393560E+00 4.23663377560E+00 4.26958092792E+00 4.30276649775E+00 4.33619195576E+00 4.36985833448E+00 4.40376726217E+00 4.43791970588E+00 4.47231715253E+00 4.50696061878E+00 4.54185174322E+00 4.57699128665E+00 4.61238089247E+00 4.64802161784E+00 4.68391462485E+00 4.72006128342E+00 4.75646268739E+00 4.79312000987E+00 4.83003457177E+00 4.86720746750E+00 4.90463973622E+00 4.94233278516E+00 4.98028751558E+00 5.01850508197E+00 5.05698671923E+00 5.09573350480E+00 5.13474635485E+00 5.17402648036E+00 5.21357486500E+00 5.25339253831E+00 5.29348057016E+00 5.33383973327E+00 5.37447130325E+00 5.41537604331E+00 5.45655498591E+00 5.49800881149E+00 5.53973861851E+00 5.58174515373E+00 5.62402938333E+00 5.66659188022E+00 5.70943372743E+00 5.75255534794E+00 5.79595777480E+00 5.83964138263E+00 5.88360699339E+00 5.92785537180E+00 5.97238676858E+00 6.01720212202E+00 6.06230160857E+00 6.10768599977E+00 6.15335562640E+00 6.19931081314E+00 6.24555202865E+00 6.29207961320E+00 6.33889372708E+00 6.38599484508E+00 6.43338287092E+00 6.48105811227E+00 6.52902064398E+00 6.57727052432E+00 6.62580769787E+00 6.67463217371E+00 6.72374369811E+00 6.77314229375E+00 6.82282752974E+00 6.87279930806E+00 6.92305709204E+00 6.97360051522E+00 7.02442927400E+00 7.07554250055E+00 7.12693983265E+00 7.17862039629E+00 7.23058359080E+00 7.28282837589E+00 7.33535402461E+00 7.38815940275E+00 7.44124347223E+00 7.49460507443E+00 7.54824291063E+00 7.60215569080E+00 7.65634192904E+00 7.71080006637E+00 7.76552856207E+00 7.82052556525E+00 7.87578942775E+00 7.93131799149E+00 7.98710940472E+00 8.04316143617E+00 8.09947175038E+00 8.15603809561E+00 8.21285779875E+00 8.26992850199E+00 8.32724720485E+00 8.38481106377E+00 8.44261719426E+00 8.50066234041E+00 8.55894328931E+00 8.61745651934E+00 8.67619854526E+00 8.73516562411E+00 8.79435394804E+00 8.85375935007E+00 8.91337774809E+00 8.97320473470E+00 9.03323585458E+00 9.09346639065E+00 9.15389141754E+00 9.21450593358E+00 9.27530480707E+00 9.33628240893E+00 9.39743327788E+00 9.45875164989E+00 9.52023140567E+00 9.58186634815E+00 9.64365010003E+00 9.70557595505E+00 9.76763709961E+00 9.82982650928E+00 9.89213675373E+00 9.95456036600E+00 1.00170895620E+01 1.00797162462E+01 1.01424322179E+01 1.02052288126E+01 1.02680973951E+01 1.03310287739E+01 1.03940136951E+01 1.04570424359E+01 1.05201052442E+01 1.05831918873E+01 1.06462918462E+01 1.07093943921E+01 1.07724884191E+01 1.08355625344E+01 1.08986050224E+01 1.09616039043E+01 1.10245467919E+01 1.10874208735E+01 1.11502132660E+01 1.12129105578E+01 1.12754989374E+01 1.13379643670E+01 1.14002923029E+01 1.14624679459E+01 1.15244760659E+01 1.15863011167E+01 1.16479270207E+01 1.17093373943E+01 1.17705155209E+01 1.18314440482E+01 1.18921054166E+01 1.19524815943E+01 1.20125540598E+01 1.20723039098E+01 1.21317117713E+01 1.21907578457E+01 1.22494218437E+01 1.23076830533E+01 1.23655202953E+01 1.24229118939E+01 1.24798357092E+01 1.25362690779E+01 1.25921889324E+01 1.26475716901E+01 1.27023931521E+01 1.27566287651E+01 1.28102534048E+01 1.28632413872E+01 1.29155666354E+01 1.29672023388E+01 1.30181214807E+01 1.30682962067E+01 1.31176982979E+01 1.31662989334E+01 1.32140688076E+01 1.32609780097E+01 1.33069961289E+01 1.33520922636E+01 1.33962348354E+01 1.34393918748E+01 1.34815306931E+01 1.35226182428E+01 1.35626207803E+01 1.36015042128E+01 1.36392336632E+01 1.36757739308E+01 1.37110891753E+01 1.37451430034E+01 1.37778986966E+01 1.38093187708E+01 1.38393653983E+01 1.38680001779E+01 1.38951842804E+01 1.39208783818E+01 1.39450426585E+01 1.39676368379E+01 1.39886202739E+01 1.40079517651E+01 1.40255899104E+01 1.40414926371E+01 1.40556177925E+01 1.40679226050E+01 1.40783641842E+01 1.40868991875E+01 1.40934841169E+01 1.40980750767E+01 1.41006280699E+01 1.41010988208E+01 1.40994429694E+01 1.40956159301E+01 1.40895730968E+01 1.40812697870E+01 1.40706612738E+01 1.40577029427E+01 1.40423501676E+01 1.40245584878E+01 1.40042835917E+01 1.39814814242E+01 1.39561082300E+01 1.39281205005E+01 1.38974752611E+01 1.38641298872E+01 1.38280423379E+01 1.37891711776E+01 1.37474756415E+01 1.37029156925E+01 1.36554521981E+01 1.36050468240E+01 1.35516623657E+01 1.34952626024E+01 1.34358125474E+01 1.33732785161E+01 1.33076281203E+01 1.32388305437E+01 1.31668565206E+01 1.30916784937E+01 1.30132706822E+01 1.29316093234E+01 1.28466726222E+01 1.27584410017E+01 1.26668971762E+01 1.25720263096E+01 1.24738161711E+01 1.23722571344E+01 1.22673425843E+01 1.21590687360E+01 1.20474350799E+01 1.19324443195E+01 1.18141026308E+01 1.16924198019E+01 1.15674093351E+01 1.14390887100E+01 1.13074794289E+01 1.11726072224E+01 1.10345022521E+01 1.08931992284E+01 1.07487375539E+01 1.06011615074E+01 1.04505204330E+01 1.02968688524E+01 1.01402666092E+01 9.98077911546E+00 9.81847731403E+00 9.65343804693E+00 9.48574400178E+00 9.31548396078E+00 9.14275288299E+00 8.96765195327E+00 8.79028884065E+00 8.61077759769E+00 8.42923895587E+00 8.24580016895E+00 8.06059523916E+00 7.87376486105E+00 7.68545645282E+00 7.49582418080E+00 7.30502890773E+00 7.11323813681E+00 6.92062597414E+00 6.72737299180E+00 6.53366610181E+00 6.33969842495E+00 6.14566905211E+00 5.95178281143E+00 5.75825003497E+00 5.56528622699E+00 5.37311167681E+00 5.18195112295E+00 4.99203319603E+00 4.80359002388E+00 4.61685663486E+00 4.43207029058E+00 4.24946988618E+00 4.06929519073E+00 3.89178598890E+00 3.71718127931E+00 3.54571834800E+00 3.37763166175E+00 3.21315186912E+00 3.05250459459E+00 2.89590922826E+00 2.74357754975E+00 2.59571239261E+00 2.45250606911E+00 2.31413892931E+00 2.18077759211E+00 2.05257325750E+00 1.92965992099E+00 1.81215245960E+00 1.70014465269E+00 1.59370720013E+00 1.49288555114E+00 1.39769778547E+00 1.30813241954E+00 1.22414608303E+00 1.14566131023E+00 1.07256415721E+00 1.00470195863E+00 9.41880935916E-01 8.83864013190E-01 8.30368517334E-01 7.81064056100E-01 7.35570489848E-01 6.93455945812E-01 6.54235150587E-01 6.17367802260E-01 5.82257310992E-01 5.48249746473E-01 5.14633170999E-01 4.80637349987E-01 4.45433904900E-01 4.08136980543E-01 3.67804485344E-01 3.23440032792E-01 2.73995523979E-01 2.18374608766E-01 1.55437063460E-01 8.40040414209E-02 2.86451404748E-03 -8.92171972733E-02 -1.93492539019E-01 -3.11218659872E-01 -4.43646661776E-01 -5.92008594777E-01 -7.57502640590E-01 -9.41276736192E-01 -1.14441048573E+00 -1.36789535659E+00 -1.61261305442E+00 -1.87931236970E+00 -2.16858426507E+00 -2.48083557939E+00 -2.81626143426E+00 -3.17481663165E+00 -3.55618645374E+00 -3.95975725336E+00 -4.38458755140E+00 -4.82938033710E+00 -5.29245747612E+00 -5.77173752880E+00 -6.26471811202E+00 -6.76846477447E+00 -7.27960813768E+00 -7.79435179799E+00 -8.30849382020E+00 -8.81746498619E+00 -9.31638781841E+00 -9.80016083614E+00 -1.02635732532E+01 -1.07014563421E+01 -1.11088784152E+01 -1.14813917093E+01 -1.18153405513E+01 -1.21082416296E+01 -1.23592489372E+01 -1.25697176031E+01 -1.27438830113E+01 -1.28874695177E+01 -1.30002539350E+01 -1.30801313628E+01 -1.31249271163E+01 -1.31323966377E+01 -1.31002255952E+01 -1.30260301881E+01 -1.29073576581E+01 -1.27416870841E+01 -1.25264303629E+01 -1.22589335431E+01 -1.19364784152E+01 -1.15562844465E+01 -1.11155110330E+01 -1.06112601403E+01 -1.00405793402E+01 -9.40046523200E+00 -8.68786734918E+00 -7.89969246029E+00 -7.03280971739E+00 -6.08405330082E+00 -5.05025477749E+00 -3.92799114959E+00 -2.71611964971E+00 -1.39106258576E+00 -1.48627812544E-01 1.48353608514E-02 -1.48079883431E-03 1.47806580010E-04 -1.47536015435E-05 1.47257590027E-06 -1.46854370713E-07 1.47130762545E-08 -1.52132420516E-09 -8.57612181340E-12 7.65735545271E-11 2 0 Beta L 919 1.06254367293E-01 1.07107803456E-01 1.07968094298E-01 1.08835294870E-01 1.09710243275E-01 1.10586918476E-01 1.11480435822E-01 1.12368743122E-01 1.13277964349E-01 1.14184384485E-01 1.15102578694E-01 1.16029477428E-01 1.16960964564E-01 1.17902475610E-01 1.18843006317E-01 1.19800375654E-01 1.20767247022E-01 1.21732963698E-01 1.22715918830E-01 1.23696155253E-01 1.24690438737E-01 1.25692447739E-01 1.26699428817E-01 1.27723676177E-01 1.28747391055E-01 1.29776690142E-01 1.30822735206E-01 1.31870187809E-01 1.32935128758E-01 1.33998902202E-01 1.35072454545E-01 1.36161234767E-01 1.37251845444E-01 1.38354343733E-01 1.39472340144E-01 1.40585358491E-01 1.41716192304E-01 1.42856476120E-01 1.44000214774E-01 1.45162126979E-01 1.46328806840E-01 1.47497414195E-01 1.48687231229E-01 1.49873753335E-01 1.51087682893E-01 1.52298453976E-01 1.53519081060E-01 1.54754571471E-01 1.55996772253E-01 1.57247785532E-01 1.58515469603E-01 1.59788329972E-01 1.61066902887E-01 1.62361181921E-01 1.63664797708E-01 1.64979802424E-01 1.66305736576E-01 1.67641310683E-01 1.68988924539E-01 1.70346519913E-01 1.71714376935E-01 1.73093682713E-01 1.74485067685E-01 1.75885914903E-01 1.77298679443E-01 1.78721825565E-01 1.80158461160E-01 1.81603185761E-01 1.83064432171E-01 1.84535924112E-01 1.86014477778E-01 1.87509240310E-01 1.89013621404E-01 1.90531322179E-01 1.92064779822E-01 1.93605532919E-01 1.95160543701E-01 1.96730131882E-01 1.98308556176E-01 1.99903950482E-01 2.01507754129E-01 2.03124511855E-01 2.04758921457E-01 2.06402470555E-01 2.08056827019E-01 2.09732315207E-01 2.11414821701E-01 2.13114997399E-01 2.14823890062E-01 2.16552716567E-01 2.18288829103E-01 2.20043417587E-01 2.21807761721E-01 2.23593949121E-01 2.25384394536E-01 2.27197009164E-01 2.29023141529E-01 2.30863010773E-01 2.32716003739E-01 2.34583054289E-01 2.36469018862E-01 2.38368569431E-01 2.40285772560E-01 2.42213357061E-01 2.44157534950E-01 2.46118745248E-01 2.48094248010E-01 2.50089867384E-01 2.52096350408E-01 2.54120965224E-01 2.56164929687E-01 2.58218128883E-01 2.60295693664E-01 2.62384864972E-01 2.64493631229E-01 2.66615208874E-01 2.68760004179E-01 2.70914971627E-01 2.73094517849E-01 2.75286001991E-01 2.77496604665E-01 2.79726649409E-01 2.81972731341E-01 2.84237645327E-01 2.86520381506E-01 2.88821240338E-01 2.91141211551E-01 2.93478129419E-01 2.95837545960E-01 2.98212855776E-01 3.00608520312E-01 3.03022484207E-01 3.05455079153E-01 3.07909100612E-01 3.10382515843E-01 3.12874981103E-01 3.15387052715E-01 3.17920687325E-01 3.20473776365E-01 3.23047130879E-01 3.25642436541E-01 3.28257351062E-01 3.30894332768E-01 3.33551227785E-01 3.36231314348E-01 3.38930971176E-01 3.41652468197E-01 3.44398523980E-01 3.47164762832E-01 3.49950326838E-01 3.52762826937E-01 3.55596016708E-01 3.58448982214E-01 3.61329400183E-01 3.64229000967E-01 3.67157118750E-01 3.70104282692E-01 3.73078080534E-01 3.76074252091E-01 3.79093921393E-01 3.82140558824E-01 3.85207819093E-01 3.88301371787E-01 3.91418746393E-01 3.94563877837E-01 3.97732007977E-01 4.00927626871E-01 4.04146570776E-01 4.07393014531E-01 4.10663865363E-01 4.13963569941E-01 4.17286029249E-01 4.20639656045E-01 4.24016526688E-01 4.27421405896E-01 4.30854442417E-01 4.34312976921E-01 4.37802347581E-01 4.41319580431E-01 4.44861108404E-01 4.48436111008E-01 4.52037050074E-01 4.55666654830E-01 4.59325509890E-01 4.63014478743E-01 4.66733542826E-01 4.70480672054E-01 4.74260463086E-01 4.78066597584E-01 4.81908591175E-01 4.85777865639E-01 4.89679007860E-01 4.93611027471E-01 4.97574924607E-01 5.01570373681E-01 5.05598858846E-01 5.09658775266E-01 5.13751007329E-01 5.17877494145E-01 5.22036888340E-01 5.26227538677E-01 5.30453801808E-01 5.34713960527E-01 5.39007499303E-01 5.43335966419E-01 5.47698163473E-01 5.52097924388E-01 5.56530383437E-01 5.60999933443E-01 5.65503892116E-01 5.70044917212E-01 5.74622283103E-01 5.79237761670E-01 5.83887891823E-01 5.88576923844E-01 5.93303219639E-01 5.98067564207E-01 6.02869459254E-01 6.07710938363E-01 6.12590646646E-01 6.17509738596E-01 6.22467784758E-01 6.27467649287E-01 6.32503932416E-01 6.37583005454E-01 6.42702117722E-01 6.47863125305E-01 6.53065744268E-01 6.58309090142E-01 6.63595044544E-01 6.68923987554E-01 6.74295036659E-01 6.79707875225E-01 6.85165276050E-01 6.90666897230E-01 6.96213000399E-01 7.01802694901E-01 7.07438097507E-01 7.13116791655E-01 7.18843090073E-01 7.24613989629E-01 7.30432308124E-01 7.36297093870E-01 7.42208496563E-01 7.48166995224E-01 7.54174492857E-01 7.60228848103E-01 7.66332635950E-01 7.72484783832E-01 7.78686780878E-01 7.84937805791E-01 7.91239626089E-01 7.97591917989E-01 8.03995308339E-01 8.10450696510E-01 8.16955674980E-01 8.23513710963E-01 8.30125725221E-01 8.36789539667E-01 8.43507361329E-01 8.50278653212E-01 8.57103886872E-01 8.63984641410E-01 8.70920410970E-01 8.77911078398E-01 8.84959167715E-01 8.92062282318E-01 8.99223715590E-01 9.06441625240E-01 9.13717498367E-01 9.21051444740E-01 9.28444663130E-01 9.35896607927E-01 9.43409003796E-01 9.50981499444E-01 9.58614622929E-01 9.66309100443E-01 9.74064279096E-01 9.81882305939E-01 9.89763398929E-01 9.97706957478E-01 1.00571422150E+00 1.01378635317E+00 1.02192229644E+00 1.03012512208E+00 1.03839059056E+00 1.04672513679E+00 1.05512510185E+00 1.06359248069E+00 1.07212855236E+00 1.08073104798E+00 1.08940433232E+00 1.09814715283E+00 1.10695881709E+00 1.11584116431E+00 1.12479545995E+00 1.13382111317E+00 1.14291862762E+00 1.15208916535E+00 1.16133375986E+00 1.17065193950E+00 1.18004448693E+00 1.18951283847E+00 1.19905632506E+00 1.20867718796E+00 1.21837386945E+00 1.22814861814E+00 1.23800197428E+00 1.24793378789E+00 1.25794549299E+00 1.26803662347E+00 1.27820893172E+00 1.28846298174E+00 1.29879835244E+00 1.30921701852E+00 1.31971864542E+00 1.33030448565E+00 1.34097507896E+00 1.35173082720E+00 1.36257240824E+00 1.37350094399E+00 1.38451725522E+00 1.39562129492E+00 1.40681392014E+00 1.41809641399E+00 1.42946881764E+00 1.44093213585E+00 1.45248720688E+00 1.46413483012E+00 1.47587543653E+00 1.48770919588E+00 1.49963865870E+00 1.51166265481E+00 1.52378270997E+00 1.53599994825E+00 1.54831461436E+00 1.56072781636E+00 1.57324009858E+00 1.58585247634E+00 1.59856525700E+00 1.61137933835E+00 1.62429643089E+00 1.63731595448E+00 1.65043975059E+00 1.66366811424E+00 1.67700219841E+00 1.69044237733E+00 1.70399005120E+00 1.71764646442E+00 1.73141078740E+00 1.74528524348E+00 1.75927039341E+00 1.77336715117E+00 1.78757624978E+00 1.80189833841E+00 1.81633507803E+00 1.83088683936E+00 1.84555379853E+00 1.86033894198E+00 1.87524084301E+00 1.89026231901E+00 1.90540260587E+00 1.92066376080E+00 1.93604645347E+00 1.95155176028E+00 1.96718022855E+00 1.98293350283E+00 1.99881211909E+00 2.01481688559E+00 2.03094859304E+00 2.04720982822E+00 2.06359892276E+00 2.08011981019E+00 2.09677089276E+00 2.11355502301E+00 2.13047217058E+00 2.14752413100E+00 2.16471135955E+00 2.18203511846E+00 2.19949663403E+00 2.21709683153E+00 2.23483636767E+00 2.25271749643E+00 2.27074014830E+00 2.28890564276E+00 2.30721550266E+00 2.32567069686E+00 2.34427199351E+00 2.36302084942E+00 2.38191842809E+00 2.40096573916E+00 2.42016395825E+00 2.43951438267E+00 2.45901810097E+00 2.47867601148E+00 2.49849006842E+00 2.51846025055E+00 2.53858921325E+00 2.55887692238E+00 2.57932542578E+00 2.59993542098E+00 2.62070843762E+00 2.64164578226E+00 2.66274822900E+00 2.68401793189E+00 2.70545459718E+00 2.72706170911E+00 2.74883853325E+00 2.77078754239E+00 2.79290942388E+00 2.81520579671E+00 2.83767823590E+00 2.86032773506E+00 2.88315553840E+00 2.90616305525E+00 2.92935202855E+00 2.95272329397E+00 2.97627836688E+00 3.00001928733E+00 3.02394613595E+00 3.04806168568E+00 3.07236630478E+00 3.09686204087E+00 3.12155000750E+00 3.14643190177E+00 3.17150893286E+00 3.19678254298E+00 3.22225430824E+00 3.24792579174E+00 3.27379844770E+00 3.29987372976E+00 3.32615272364E+00 3.35263769839E+00 3.37932957504E+00 3.40623035817E+00 3.43334123889E+00 3.46066390104E+00 3.48819964451E+00 3.51595055857E+00 3.54391733517E+00 3.57210278274E+00 3.60050744031E+00 3.62913336145E+00 3.65798226640E+00 3.68705530785E+00 3.71635461096E+00 3.74588137635E+00 3.77563768533E+00 3.80562504428E+00 3.83584486201E+00 3.86629904832E+00 3.89698934716E+00 3.92791713620E+00 3.95908428556E+00 3.99049268930E+00 4.02214369401E+00 4.05403923637E+00 4.08618122505E+00 4.11857097400E+00 4.15121044378E+00 4.18410162320E+00 4.21724575334E+00 4.25064503704E+00 4.28430101609E+00 4.31821562524E+00 4.35239060549E+00 4.38682759969E+00 4.42152875953E+00 4.45649570468E+00 4.49173014952E+00 4.52723383932E+00 4.56300926957E+00 4.59905751973E+00 4.63538077567E+00 4.67198057840E+00 4.70885961990E+00 4.74601869557E+00 4.78346039539E+00 4.82118642522E+00 4.85919861317E+00 4.89749880084E+00 4.93608911350E+00 4.97497124928E+00 5.01414716221E+00 5.05361891913E+00 5.09338804570E+00 5.13345678982E+00 5.17382715608E+00 5.21450083974E+00 5.25547973987E+00 5.29676602030E+00 5.33836141319E+00 5.38026807695E+00 5.42248785066E+00 5.46502256719E+00 5.50787427348E+00 5.55104498874E+00 5.59453666778E+00 5.63835108858E+00 5.68249032995E+00 5.72695647419E+00 5.77175118318E+00 5.81687659161E+00 5.86233468332E+00 5.90812728991E+00 5.95425658035E+00 6.00072419657E+00 6.04753228328E+00 6.09468286712E+00 6.14217764550E+00 6.19001879457E+00 6.23820792142E+00 6.28674741058E+00 6.33563878780E+00 6.38488425746E+00 6.43448541306E+00 6.48444466049E+00 6.53476326358E+00 6.58544363829E+00 6.63648743837E+00 6.68789645571E+00 6.73967275643E+00 6.79181804660E+00 6.84433413947E+00 6.89722304181E+00 6.95048646661E+00 7.00412605790E+00 7.05814394069E+00 7.11254158272E+00 7.16732078305E+00 7.22248344841E+00 7.27803128098E+00 7.33396577621E+00 7.39028881473E+00 7.44700198241E+00 7.50410692812E+00 7.56160535354E+00 7.61949857686E+00 7.67778857192E+00 7.73647664777E+00 7.79556446558E+00 7.85505323008E+00 7.91494469239E+00 7.97524014749E+00 8.03594117755E+00 8.09704885493E+00 8.15856491813E+00 8.22049024737E+00 8.28282651980E+00 8.34557455631E+00 8.40873576292E+00 8.47231147206E+00 8.53630234900E+00 8.60070995649E+00 8.66553486579E+00 8.73077842624E+00 8.79644141399E+00 8.86252459895E+00 8.92902894033E+00 8.99595523254E+00 9.06330403551E+00 9.13107632191E+00 9.19927232169E+00 9.26789279216E+00 9.33693818925E+00 9.40640894874E+00 9.47630535960E+00 9.54662779655E+00 9.61737629301E+00 9.68855124387E+00 9.76015245496E+00 9.83218016623E+00 9.90463404814E+00 9.97751399343E+00 1.00508199786E+01 1.01245512454E+01 1.01987076960E+01 1.02732885662E+01 1.03482934493E+01 1.04237213667E+01 1.04995717483E+01 1.05758434950E+01 1.06525356327E+01 1.07296470316E+01 1.08071763796E+01 1.08851223763E+01 1.09634834666E+01 1.10422580004E+01 1.11214443517E+01 1.12010404901E+01 1.12810446501E+01 1.13614544011E+01 1.14422677114E+01 1.15234820551E+01 1.16050947695E+01 1.16871033009E+01 1.17695045457E+01 1.18522958103E+01 1.19354735630E+01 1.20190344753E+01 1.21029751645E+01 1.21872917623E+01 1.22719804551E+01 1.23570370253E+01 1.24424573010E+01 1.25282367724E+01 1.26143708430E+01 1.27008544461E+01 1.27876826229E+01 1.28748499880E+01 1.29623510907E+01 1.30501801360E+01 1.31383310541E+01 1.32267976718E+01 1.33155736433E+01 1.34046519700E+01 1.34940258676E+01 1.35836881530E+01 1.36736311750E+01 1.37638471755E+01 1.38543281567E+01 1.39450656857E+01 1.40360511838E+01 1.41272757911E+01 1.42187301120E+01 1.43104046958E+01 1.44022896708E+01 1.44943747522E+01 1.45866495090E+01 1.46791028974E+01 1.47717239023E+01 1.48645007748E+01 1.49574216736E+01 1.50504741364E+01 1.51436456513E+01 1.52369230690E+01 1.53302928542E+01 1.54237411867E+01 1.55172537408E+01 1.56108158034E+01 1.57044122264E+01 1.57980275034E+01 1.58916455795E+01 1.59852498309E+01 1.60788235241E+01 1.61723492194E+01 1.62658089368E+01 1.63591843829E+01 1.64524565848E+01 1.65456062160E+01 1.66386133666E+01 1.67314576925E+01 1.68241181337E+01 1.69165732072E+01 1.70088009707E+01 1.71007786276E+01 1.71924830835E+01 1.72838906010E+01 1.73749767748E+01 1.74657166718E+01 1.75560847156E+01 1.76460547420E+01 1.77355999137E+01 1.78246928076E+01 1.79133053551E+01 1.80014088031E+01 1.80889737543E+01 1.81759700889E+01 1.82623671186E+01 1.83481334405E+01 1.84332368039E+01 1.85176444498E+01 1.86013228270E+01 1.86842376050E+01 1.87663538907E+01 1.88476357815E+01 1.89280470512E+01 1.90075503255E+01 1.90861076968E+01 1.91636804120E+01 1.92402290246E+01 1.93157132347E+01 1.93900920245E+01 1.94633236680E+01 1.95353654863E+01 1.96061742182E+01 1.96757055897E+01 1.97439147819E+01 1.98107559892E+01 1.98761828678E+01 1.99401479676E+01 2.00026033294E+01 2.00635000707E+01 2.01227884954E+01 2.01804183886E+01 2.02363384400E+01 2.02904967905E+01 2.03428407303E+01 2.03933168851E+01 2.04418711267E+01 2.04884485636E+01 2.05329936036E+01 2.05754500494E+01 2.06157608585E+01 2.06538686037E+01 2.06897148547E+01 2.07232409457E+01 2.07543872703E+01 2.07830939296E+01 2.08093002946E+01 2.08329453894E+01 2.08539675728E+01 2.08723049200E+01 2.08878949892E+01 2.09006750710E+01 2.09105820007E+01 2.09175524228E+01 2.09215227144E+01 2.09224290235E+01 2.09202074702E+01 2.09147939817E+01 2.09061245199E+01 2.08941350565E+01 2.08787617103E+01 2.08599408001E+01 2.08376087734E+01 2.08117025762E+01 2.07821594120E+01 2.07489170428E+01 2.07119138148E+01 2.06710887412E+01 2.06263815742E+01 2.05777330334E+01 2.05250846643E+01 2.04683792703E+01 2.04075607188E+01 2.03425742673E+01 2.02733666508E+01 2.01998860727E+01 2.01220825644E+01 2.00399079559E+01 1.99533160825E+01 1.98622628735E+01 1.97667066674E+01 1.96666081479E+01 1.95619306711E+01 1.94526403636E+01 1.93387063303E+01 1.92201008607E+01 1.90967994315E+01 1.89687812395E+01 1.88360289718E+01 1.86985293895E+01 1.85562732532E+01 1.84092556671E+01 1.82574762682E+01 1.81009393670E+01 1.79396542988E+01 1.77736354930E+01 1.76029027500E+01 1.74274815175E+01 1.72474030549E+01 1.70627046341E+01 1.68734297924E+01 1.66796285935E+01 1.64813577906E+01 1.62786810303E+01 1.60716691921E+01 1.58604003589E+01 1.56449603167E+01 1.54254425063E+01 1.52019483703E+01 1.49745874842E+01 1.47434776452E+01 1.45087452353E+01 1.42705251173E+01 1.40289610494E+01 1.37842055105E+01 1.35364200274E+01 1.32857751334E+01 1.30324504445E+01 1.27766347262E+01 1.25185258631E+01 1.22583308244E+01 1.19962656543E+01 1.17325553346E+01 1.14674336622E+01 1.12011431218E+01 1.09339346192E+01 1.06660672234E+01 1.03978079094E+01 1.01294311733E+01 9.86121857671E+00 9.59345835821E+00 9.32644475777E+00 9.06047755288E+00 8.79586133232E+00 8.53290467838E+00 8.27191943720E+00 8.01321978107E+00 7.75712114185E+00 7.50393921802E+00 7.25398881846E+00 7.00758247118E+00 6.76502917078E+00 6.52663285598E+00 6.29269087937E+00 6.06349225972E+00 5.83931598492E+00 5.62042900046E+00 5.40708437042E+00 5.19951900766E+00 4.99795150686E+00 4.80257984623E+00 4.61357891747E+00 4.43109796690E+00 4.25525802726E+00 4.08614909817E+00 3.92382738822E+00 3.76831245331E+00 3.61958415885E+00 3.47757978436E+00 3.34219089290E+00 3.21326037392E+00 3.09057928340E+00 2.97388394485E+00 2.86285288935E+00 2.75710401626E+00 2.65619186517E+00 2.55960493057E+00 2.46676337909E+00 2.37701680513E+00 2.28964245294E+00 2.20384369410E+00 2.11874899292E+00 2.03341134873E+00 1.94680829906E+00 1.85784257749E+00 1.76534350238E+00 1.66806926289E+00 1.56471002486E+00 1.45389216521E+00 1.33418368535E+00 1.20410074676E+00 1.06211574329E+00 9.06666781401E-01 7.36168907341E-01 5.49026865558E-01 3.43650041244E-01 1.18469032679E-01 -1.28045420550E-01 -3.97361478464E-01 -6.90863008673E-01 -1.00982415284E+00 -1.35538150902E+00 -1.72850430617E+00 -2.12996226391E+00 -2.56029162019E+00 -3.01975943124E+00 -3.50832651039E+00 -4.02560953245E+00 -4.57084279805E+00 -5.14284057971E+00 -5.73996094314E+00 -6.36007220755E+00 -7.00052372700E+00 -7.65812245107E+00 -8.32911781289E+00 -9.00919720741E+00 -9.69349528810E+00 -1.03766207469E+01 -1.10527046733E+01 -1.17154757020E+01 -1.23583677294E+01 -1.29746669521E+01 -1.35577063079E+01 -1.41011163360E+01 -1.45991432203E+01 -1.50470461907E+01 -1.54415883479E+01 -1.57816372387E+01 -1.60688936610E+01 -1.63087700169E+01 -1.65086048653E+01 -1.66680897822E+01 -1.67844947238E+01 -1.68549990324E+01 -1.68766912918E+01 -1.68465694246E+01 -1.67615410555E+01 -1.66184241406E+01 -1.64139479635E+01 -1.61447543703E+01 -1.58073994622E+01 -1.53983556197E+01 -1.49140139716E+01 -1.43506872763E+01 -1.37046133045E+01 -1.29719587369E+01 -1.21488235588E+01 -1.12312460847E+01 -1.02152084940E+01 -9.09664346557E+00 -7.87143757135E+00 -6.53547315490E+00 -5.08430198649E+00 -3.51642819575E+00 -1.80129823461E+00 -1.92496409121E-01 1.92141271713E-02 -1.91786754446E-03 1.91432782958E-04 -1.91082371213E-05 1.90721805483E-06 -1.90199108400E-07 1.90560806997E-08 -1.97071801568E-09 -1.18450360816E-11 9.93575447362E-11 3 1 Beta L 919 -1.23670591571E-03 -1.25665234195E-03 -1.27692047736E-03 -1.29751551066E-03 -1.31843219701E-03 -1.33962405559E-03 -1.36127060023E-03 -1.38316823278E-03 -1.40554514947E-03 -1.42823076986E-03 -1.45120750983E-03 -1.47465349312E-03 -1.49837065920E-03 -1.52257980627E-03 -1.54716184141E-03 -1.57209456865E-03 -1.59743137625E-03 -1.62320541646E-03 -1.64946947592E-03 -1.67597141146E-03 -1.70302227429E-03 -1.73055851747E-03 -1.75840074751E-03 -1.78678895185E-03 -1.81556165459E-03 -1.84489517157E-03 -1.87464418656E-03 -1.90488595679E-03 -1.93564342613E-03 -1.96689961109E-03 -1.99853054608E-03 -2.03079148637E-03 -2.06357587243E-03 -2.09676505392E-03 -2.13070461226E-03 -2.16495921361E-03 -2.19994298751E-03 -2.23541314247E-03 -2.27140429198E-03 -2.30812407284E-03 -2.34536679657E-03 -2.38311014606E-03 -2.42157945111E-03 -2.46061017577E-03 -2.50034878481E-03 -2.54064310920E-03 -2.58161630315E-03 -2.62324557549E-03 -2.66559133719E-03 -2.70860047836E-03 -2.75232127285E-03 -2.79663560676E-03 -2.84174580500E-03 -2.88764713073E-03 -2.93418633584E-03 -2.98147480641E-03 -3.02964909749E-03 -3.07841700598E-03 -3.12812136891E-03 -3.17859918327E-03 -3.22990270193E-03 -3.28190124899E-03 -3.33484360646E-03 -3.38868680492E-03 -3.44334824384E-03 -3.49889063526E-03 -3.55527646028E-03 -3.61266781833E-03 -3.67090531823E-03 -3.73011201058E-03 -3.79030507844E-03 -3.85141794566E-03 -3.91349203586E-03 -3.97659648115E-03 -4.04082308947E-03 -4.10588270461E-03 -4.17219242589E-03 -4.23952188103E-03 -4.30783762045E-03 -4.37733812274E-03 -4.44789813517E-03 -4.51967465909E-03 -4.59259201287E-03 -4.66669551481E-03 -4.74187493437E-03 -4.81834135024E-03 -4.89608396235E-03 -4.97512427094E-03 -5.05531896706E-03 -5.13689224221E-03 -5.21974752757E-03 -5.30387552325E-03 -5.38948641942E-03 -5.47632347768E-03 -5.56467019310E-03 -5.65443811120E-03 -5.74569001498E-03 -5.83830036236E-03 -5.93255291773E-03 -6.02820714931E-03 -6.12544323705E-03 -6.22415905233E-03 -6.32460429555E-03 -6.42665433221E-03 -6.53029808173E-03 -6.63556633827E-03 -6.74260931144E-03 -6.85140363923E-03 -6.96186091666E-03 -7.07416972656E-03 -7.18824517333E-03 -7.30419322353E-03 -7.42202969051E-03 -7.54170854774E-03 -7.66332045252E-03 -7.78700692046E-03 -7.91250402721E-03 -8.04019893450E-03 -8.16980747496E-03 -8.30162850091E-03 -8.43553260918E-03 -8.57155152539E-03 -8.70986111248E-03 -8.85031178198E-03 -8.99301361120E-03 -9.13818869497E-03 -9.28550207793E-03 -9.43523360731E-03 -9.58748703584E-03 -9.74204376918E-03 -9.89916462481E-03 -1.00589230638E-02 -1.02210489751E-02 -1.03858959005E-02 -1.05534469166E-02 -1.07236978245E-02 -1.08966658366E-02 -1.10723920223E-02 -1.12509727731E-02 -1.14324441871E-02 -1.16169169649E-02 -1.18041568356E-02 -1.19946127038E-02 -1.21880343454E-02 -1.23845813681E-02 -1.25844318433E-02 -1.27873876907E-02 -1.29936236928E-02 -1.32031877677E-02 -1.34161541825E-02 -1.36324936583E-02 -1.38523847018E-02 -1.40758625985E-02 -1.43028111726E-02 -1.45335488034E-02 -1.47679386577E-02 -1.50061058099E-02 -1.52481658369E-02 -1.54941149301E-02 -1.57440755826E-02 -1.59979749405E-02 -1.62560127721E-02 -1.65181404921E-02 -1.67846207706E-02 -1.70552916772E-02 -1.73304722883E-02 -1.76099323751E-02 -1.78939529200E-02 -1.81825964467E-02 -1.84758250535E-02 -1.87738802796E-02 -1.90766635416E-02 -1.93844249021E-02 -1.96969226046E-02 -2.00147665135E-02 -2.03374614758E-02 -2.06654922305E-02 -2.09987480919E-02 -2.13375474813E-02 -2.16816901020E-02 -2.20313465000E-02 -2.23866986566E-02 -2.27478172806E-02 -2.31146168611E-02 -2.34874515638E-02 -2.38663907836E-02 -2.42512745746E-02 -2.46424406100E-02 -2.50398929685E-02 -2.54437790548E-02 -2.58541322133E-02 -2.62711630754E-02 -2.66948768035E-02 -2.71254961442E-02 -2.75629617683E-02 -2.80075711499E-02 -2.84592686713E-02 -2.89182666871E-02 -2.93847145410E-02 -2.98586786052E-02 -3.03402820578E-02 -3.08295909456E-02 -3.13268868099E-02 -3.18321486921E-02 -3.23455062859E-02 -3.28673053540E-02 -3.33973790921E-02 -3.39361603806E-02 -3.44834476216E-02 -3.50396289751E-02 -3.56047676259E-02 -3.61790529971E-02 -3.67626317970E-02 -3.73555700827E-02 -3.79580597557E-02 -3.85703018367E-02 -3.91923919520E-02 -3.98245539731E-02 -4.04669306943E-02 -4.11197239084E-02 -4.17827568233E-02 -4.24568038072E-02 -4.31415963248E-02 -4.38374204078E-02 -4.45444866695E-02 -4.52629490000E-02 -4.59929963356E-02 -4.67348230051E-02 -4.74886728769E-02 -4.82545981015E-02 -4.90329369635E-02 -4.98238619868E-02 -5.06274014118E-02 -5.14440143000E-02 -5.22737550821E-02 -5.31169339541E-02 -5.39736492048E-02 -5.48442359860E-02 -5.57288563202E-02 -5.66277408489E-02 -5.75410992103E-02 -5.84692351127E-02 -5.94123338716E-02 -6.03705775323E-02 -6.13443431143E-02 -6.23337992999E-02 -6.33392482026E-02 -6.43608675258E-02 -6.53988823256E-02 -6.64538524601E-02 -6.75256531752E-02 -6.86148418595E-02 -6.97215298850E-02 -7.08462667779E-02 -7.19888722080E-02 -7.31500322193E-02 -7.43299301558E-02 -7.55288389374E-02 -7.67471747026E-02 -7.79849992195E-02 -7.92429384209E-02 -8.05210717085E-02 -8.18198760342E-02 -8.31396242763E-02 -8.44806304567E-02 -8.58434030833E-02 -8.72279800429E-02 -8.86349343723E-02 -9.00646821293E-02 -9.15173850483E-02 -9.29935023141E-02 -9.44935390980E-02 -9.60177111003E-02 -9.75664591622E-02 -9.91401502839E-02 -1.00739426240E-01 -1.02364278237E-01 -1.04015483557E-01 -1.05693256288E-01 -1.07398041228E-01 -1.09130416975E-01 -1.10890636365E-01 -1.12679482344E-01 -1.14496888678E-01 -1.16343912332E-01 -1.18220413533E-01 -1.20127470863E-01 -1.22065126863E-01 -1.24034138843E-01 -1.26034793632E-01 -1.28067792506E-01 -1.30133599687E-01 -1.32232695096E-01 -1.34365667541E-01 -1.36533104946E-01 -1.38735459343E-01 -1.40973375559E-01 -1.43247270048E-01 -1.45557950966E-01 -1.47905914059E-01 -1.50291759775E-01 -1.52716076531E-01 -1.55179559043E-01 -1.57682709688E-01 -1.60226288753E-01 -1.62810856789E-01 -1.65437154315E-01 -1.68105835678E-01 -1.70817452977E-01 -1.73573012234E-01 -1.76372854537E-01 -1.79218047306E-01 -1.82108958759E-01 -1.85046665136E-01 -1.88031668977E-01 -1.91064921619E-01 -1.94147019630E-01 -1.97278848412E-01 -2.00461285503E-01 -2.03694969243E-01 -2.06980899292E-01 -2.10319813346E-01 -2.13712590617E-01 -2.17160159934E-01 -2.20663552146E-01 -2.24220306294E-01 -2.27844535298E-01 -2.31513403510E-01 -2.35249173461E-01 -2.39046719571E-01 -2.42904228903E-01 -2.46812847461E-01 -2.50811391535E-01 -2.54837960873E-01 -2.58967193826E-01 -2.63134658303E-01 -2.67379495044E-01 -2.71694626304E-01 -2.76085598169E-01 -2.80525653305E-01 -2.85058553504E-01 -2.89655009562E-01 -2.94333775036E-01 -2.99076261459E-01 -3.03901295877E-01 -3.08804581110E-01 -3.13788684617E-01 -3.18851864901E-01 -3.23991748407E-01 -3.29224196632E-01 -3.34528876410E-01 -3.39930194401E-01 -3.45417260290E-01 -3.50983641841E-01 -3.56649188421E-01 -3.62401244030E-01 -3.68251422965E-01 -3.74191867317E-01 -3.80228643914E-01 -3.86359177384E-01 -3.92601331315E-01 -3.98929712383E-01 -4.05364457894E-01 -4.11911182740E-01 -4.18548622574E-01 -4.25312306742E-01 -4.32161764423E-01 -4.39146450416E-01 -4.46224458502E-01 -4.53426966536E-01 -4.60743249991E-01 -4.68175062789E-01 -4.75730951617E-01 -4.83406565825E-01 -4.91206298552E-01 -4.99133395930E-01 -5.07188405529E-01 -5.15365408524E-01 -5.23688062558E-01 -5.32135421308E-01 -5.40721311529E-01 -5.49449703099E-01 -5.58312074628E-01 -5.67323866560E-01 -5.76474796465E-01 -5.85781564903E-01 -5.95231650628E-01 -6.04836105452E-01 -6.14599688787E-01 -6.24514285832E-01 -6.34592231890E-01 -6.44835647185E-01 -6.55238771551E-01 -6.65813904554E-01 -6.76558529672E-01 -6.87476082084E-01 -6.98571217183E-01 -7.09846771631E-01 -7.21298946449E-01 -7.32942738202E-01 -7.44768812063E-01 -7.56790321641E-01 -7.69003864832E-01 -7.81413855615E-01 -7.94026841423E-01 -8.06838796361E-01 -8.19866434519E-01 -8.33093360035E-01 -8.46542623401E-01 -8.60206920141E-01 -8.74085616793E-01 -8.88199673446E-01 -9.02529458910E-01 -9.17107626105E-01 -9.31897827042E-01 -9.46953382675E-01 -9.62224397561E-01 -9.77766045446E-01 -9.93549627179E-01 -1.00957619304E+00 -1.02588898874E+00 -1.04243914336E+00 -1.05926809865E+00 -1.07636916434E+00 -1.09374462393E+00 -1.11140287471E+00 -1.12934191662E+00 -1.14757635974E+00 -1.16610229622E+00 -1.18492906665E+00 -1.20405279876E+00 -1.22350428785E+00 -1.24324881891E+00 -1.26332305420E+00 -1.28372142735E+00 -1.30444441867E+00 -1.32551413996E+00 -1.34691011549E+00 -1.36865701922E+00 -1.39076134481E+00 -1.41321052594E+00 -1.43604422279E+00 -1.45921323676E+00 -1.48279676019E+00 -1.50672738043E+00 -1.53107208007E+00 -1.55578293292E+00 -1.58091562946E+00 -1.60644959011E+00 -1.63238334230E+00 -1.65875731122E+00 -1.68554142180E+00 -1.71276683146E+00 -1.74042812296E+00 -1.76854249328E+00 -1.79710067586E+00 -1.82613317582E+00 -1.85563550738E+00 -1.88559571905E+00 -1.91607002421E+00 -1.94700941920E+00 -1.97846766213E+00 -2.01042944487E+00 -2.04290377176E+00 -2.07591304107E+00 -2.10944514557E+00 -2.14352906672E+00 -2.17815799676E+00 -2.21335799355E+00 -2.24911029523E+00 -2.28546044219E+00 -2.32238144781E+00 -2.35991155948E+00 -2.39804374651E+00 -2.43680055200E+00 -2.47617589272E+00 -2.51619136322E+00 -2.55685665877E+00 -2.59818196757E+00 -2.64016628703E+00 -2.68284573897E+00 -2.72620499454E+00 -2.77027285282E+00 -2.81504600240E+00 -2.86055321315E+00 -2.90679582875E+00 -2.95378423870E+00 -3.00153465383E+00 -3.05006277031E+00 -3.09936822004E+00 -3.14948359310E+00 -3.20040289321E+00 -3.25214928311E+00 -3.30473791974E+00 -3.35817532605E+00 -3.41247672692E+00 -3.46766124804E+00 -3.52374428589E+00 -3.58072662622E+00 -3.63864262918E+00 -3.69749261293E+00 -3.75729520431E+00 -3.81807340622E+00 -3.87983123691E+00 -3.94259197948E+00 -4.00637513680E+00 -4.07118739053E+00 -4.13705388890E+00 -4.20398790670E+00 -4.27200819612E+00 -4.34113015580E+00 -4.41137809016E+00 -4.48276079506E+00 -4.55530654626E+00 -4.62902647597E+00 -4.70394380163E+00 -4.78007764523E+00 -4.85744779002E+00 -4.93607392144E+00 -5.01597310993E+00 -5.09717434076E+00 -5.17969455054E+00 -5.26355015457E+00 -5.34877106336E+00 -5.43537570137E+00 -5.52338638923E+00 -5.61282788928E+00 -5.70372085077E+00 -5.79609148326E+00 -5.88996494239E+00 -5.98535979431E+00 -6.08230864271E+00 -6.18083229774E+00 -6.28095524211E+00 -6.38270922530E+00 -6.48611495277E+00 -6.59120140775E+00 -6.69799943799E+00 -6.80653200532E+00 -6.91682811418E+00 -7.02892319640E+00 -7.14283620730E+00 -7.25860265813E+00 -7.37625636708E+00 -7.49582131877E+00 -7.61733001738E+00 -7.74082050510E+00 -7.86631434521E+00 -7.99385642045E+00 -8.12347172330E+00 -8.25519551813E+00 -8.38906508903E+00 -8.52511403174E+00 -8.66337675497E+00 -8.80389142426E+00 -8.94669422100E+00 -9.09182040771E+00 -9.23931339916E+00 -9.38920466780E+00 -9.54153950601E+00 -9.69635514702E+00 -9.85369245145E+00 -1.00135911869E+01 -1.01760978777E+01 -1.03412496716E+01 -1.05090929277E+01 -1.06796704753E+01 -1.08530277238E+01 -1.10292103670E+01 -1.12082624898E+01 -1.13902335202E+01 -1.15751699061E+01 -1.17631185427E+01 -1.19541341820E+01 -1.21482586008E+01 -1.23455492722E+01 -1.25460548284E+01 -1.27498278216E+01 -1.29569229241E+01 -1.31673931369E+01 -1.33812928305E+01 -1.35986797607E+01 -1.38196097044E+01 -1.40441392525E+01 -1.42723284901E+01 -1.45042370376E+01 -1.47399241214E+01 -1.49794521879E+01 -1.52228829561E+01 -1.54702805156E+01 -1.57217071202E+01 -1.59772329813E+01 -1.62369172148E+01 -1.65008346333E+01 -1.67690483275E+01 -1.70416305809E+01 -1.73186508101E+01 -1.76001813377E+01 -1.78862944504E+01 -1.81770641128E+01 -1.84725658371E+01 -1.87728742402E+01 -1.90780700273E+01 -1.93882261116E+01 -1.97034279271E+01 -2.00237525974E+01 -2.03492829089E+01 -2.06801037965E+01 -2.10162966790E+01 -2.13579500052E+01 -2.17051490747E+01 -2.20579831996E+01 -2.24165395746E+01 -2.27809133021E+01 -2.31511909714E+01 -2.35274706176E+01 -2.39098429520E+01 -2.42984085104E+01 -2.46932588103E+01 -2.50944984568E+01 -2.55022223449E+01 -2.59165347689E+01 -2.63375378431E+01 -2.67653344459E+01 -2.72000313009E+01 -2.76417343773E+01 -2.80905518842E+01 -2.85465931455E+01 -2.90099695830E+01 -2.94807922251E+01 -2.99591760065E+01 -3.04452347085E+01 -3.09390854268E+01 -3.14408445728E+01 -3.19506329286E+01 -3.24685688087E+01 -3.29947753006E+01 -3.35293739924E+01 -3.40724913094E+01 -3.46242495549E+01 -3.51847786137E+01 -3.57542038471E+01 -3.63326569236E+01 -3.69202655293E+01 -3.75171637260E+01 -3.81234831758E+01 -3.87393567472E+01 -3.93649209210E+01 -4.00003106125E+01 -4.06456628802E+01 -4.13011156551E+01 -4.19668073530E+01 -4.26428776662E+01 -4.33294667861E+01 -4.40267157541E+01 -4.47347661403E+01 -4.54537606677E+01 -4.61838409300E+01 -4.69251513060E+01 -4.76778343506E+01 -4.84420346339E+01 -4.92178949895E+01 -5.00055600401E+01 -5.08051736740E+01 -5.16168790165E+01 -5.24408199131E+01 -5.32771390182E+01 -5.41259788320E+01 -5.49874809615E+01 -5.58617861335E+01 -5.67490340231E+01 -5.76493637296E+01 -5.85629111680E+01 -5.94898137544E+01 -6.04302034318E+01 -6.13842138020E+01 -6.23519732847E+01 -6.33336096386E+01 -6.43292479580E+01 -6.53390088669E+01 -6.63630120554E+01 -6.74013717506E+01 -6.84541995411E+01 -6.95216031375E+01 -7.06036847374E+01 -7.17005429948E+01 -7.28122708112E+01 -7.39389565060E+01 -7.50806812064E+01 -7.62375210335E+01 -7.74095454806E+01 -7.85968158197E+01 -7.97993877360E+01 -8.10173066673E+01 -8.22506120164E+01 -8.34993318987E+01 -8.47634870144E+01 -8.60430862734E+01 -8.73381294290E+01 -8.86486038888E+01 -8.99744859817E+01 -9.13157392588E+01 -9.26723139248E+01 -9.40441468974E+01 -9.54311603041E+01 -9.68332606031E+01 -9.82503390564E+01 -9.96822693003E+01 -1.01128907615E+02 -1.02590091953E+02 -1.04065640669E+02 -1.05555351901E+02 -1.07059002456E+02 -1.08576347231E+02 -1.10107117830E+02 -1.11651021620E+02 -1.13207740578E+02 -1.14776931052E+02 -1.16358221275E+02 -1.17951210859E+02 -1.19555470660E+02 -1.21170539544E+02 -1.22795924868E+02 -1.24431100496E+02 -1.26075505385E+02 -1.27728543058E+02 -1.29389579006E+02 -1.31057940801E+02 -1.32732915608E+02 -1.34413748909E+02 -1.36099644236E+02 -1.37789759541E+02 -1.39483207928E+02 -1.41179055126E+02 -1.42876317672E+02 -1.44573962433E+02 -1.46270903670E+02 -1.47966003459E+02 -1.49658067930E+02 -1.51345847796E+02 -1.53028034952E+02 -1.54703263024E+02 -1.56370103447E+02 -1.58027066414E+02 -1.59672597527E+02 -1.61305077669E+02 -1.62922820118E+02 -1.64524071339E+02 -1.66107007251E+02 -1.67669733878E+02 -1.69210285026E+02 -1.70726621473E+02 -1.72216630399E+02 -1.73678123232E+02 -1.75108835969E+02 -1.76506427900E+02 -1.77868480816E+02 -1.79192498474E+02 -1.80475906612E+02 -1.81716052306E+02 -1.82910203993E+02 -1.84055551590E+02 -1.85149206876E+02 -1.86188203531E+02 -1.87169498744E+02 -1.88089973139E+02 -1.88946432380E+02 -1.89735609252E+02 -1.90454164541E+02 -1.91098688958E+02 -1.91665706844E+02 -1.92151677451E+02 -1.92552998663E+02 -1.92866010390E+02 -1.93086999012E+02 -1.93212200117E+02 -1.93237805585E+02 -1.93159965939E+02 -1.92974799081E+02 -1.92678393735E+02 -1.92266818473E+02 -1.91736127073E+02 -1.91082368286E+02 -1.90301592347E+02 -1.89389861705E+02 -1.88343259922E+02 -1.87157902092E+02 -1.85829945877E+02 -1.84355603880E+02 -1.82731155005E+02 -1.80952958760E+02 -1.79017468451E+02 -1.76921246011E+02 -1.74660977993E+02 -1.72233490595E+02 -1.69635767982E+02 -1.66864969299E+02 -1.63918447314E+02 -1.60793767811E+02 -1.57488729808E+02 -1.54001385971E+02 -1.50330064687E+02 -1.46473391904E+02 -1.42430314803E+02 -1.38200124286E+02 -1.33782480204E+02 -1.29177435886E+02 -1.24385462728E+02 -1.19407477284E+02 -1.14244866034E+02 -1.08899512654E+02 -1.03373824318E+02 -9.76707580101E+01 -9.17938483438E+01 -8.57472327252E+01 -7.95356785878E+01 -7.31646088542E+01 -6.66401273258E+01 -5.99690430342E+01 -5.31588939753E+01 -4.62179690194E+01 -3.91553296819E+01 -3.19808281517E+01 -2.47051259478E+01 -1.73397082166E+01 -9.89689659002E+00 -2.38985891208E+00 5.16738382898E+00 1.27599550512E+01 2.03721232622E+01 2.79873069647E+01 3.55880853998E+01 4.31562136865E+01 5.06726440830E+01 5.81175528395E+01 6.54703753425E+01 7.27098468151E+01 7.98140520554E+01 8.67604830401E+01 9.35261063120E+01 1.00087438369E+02 1.06420633420E+02 1.12501579570E+02 1.18306008267E+02 1.23809614032E+02 1.28988187438E+02 1.33817759845E+02 1.38274762127E+02 1.42336195427E+02 1.45979816522E+02 1.49184335276E+02 1.51929626063E+02 1.54196951361E+02 1.55969197056E+02 1.57231119627E+02 1.57969601635E+02 1.58173915858E+02 1.57835994397E+02 1.56950700220E+02 1.55516097940E+02 1.53533719064E+02 1.51008815846E+02 1.47950598941E+02 1.44372449457E+02 1.40292098001E+02 1.35731758939E+02 1.30718208767E+02 1.25282792691E+02 1.19461344342E+02 1.13293997534E+02 1.06824869069E+02 1.00101585114E+02 9.31746229724E+01 8.60964325014E+01 7.89202982837E+01 7.16988978461E+01 6.44825031317E+01 5.73167675347E+01 5.02400294297E+01 4.32800565505E+01 3.64501418841E+01 2.97444520146E+01 2.31325137789E+01 1.65731302423E+01 1.00832867016E+01 3.69903856095E+00 -2.54149374642E+00 -8.59809652355E+00 -1.44284399883E+01 -1.99880616271E+01 -2.52303555010E+01 -3.01065693999E+01 -3.45658090800E+01 -3.85550517442E+01 -4.20191684291E+01 -4.49009564853E+01 -4.71411829098E+01 -4.86786392912E+01 -4.94502091980E+01 -4.93909492675E+01 -4.84341838483E+01 -4.65116153218E+01 -4.35534522637E+01 -3.94885314420E+01 -3.42446870148E+01 -2.77468954370E+01 -1.99373786882E+01 -1.05811501007E+01 -1.17034840445E+00 1.16818923503E-01 -1.16603399661E-02 1.16388009136E-03 -1.16171202923E-04 1.15891917354E-05 -1.15789765462E-06 1.13358404464E-07 -1.16152579698E-08 3.70537513324E-09 -4.85441631381E-10 4 1 Beta L 919 1.64225384558E-03 1.66874122477E-03 1.69565581003E-03 1.72300449161E-03 1.75078232991E-03 1.77892094105E-03 1.80766727119E-03 1.83674373889E-03 1.86646069413E-03 1.89658624027E-03 1.92709564641E-03 1.95823129565E-03 1.98972381397E-03 2.02187301412E-03 2.05451701128E-03 2.08762500644E-03 2.12126993856E-03 2.15549614492E-03 2.19037563148E-03 2.22556495908E-03 2.26148684786E-03 2.29805530445E-03 2.33502543544E-03 2.37272366734E-03 2.41093010693E-03 2.44988461869E-03 2.48938841135E-03 2.52954768487E-03 2.57039255143E-03 2.61189954448E-03 2.65389996346E-03 2.69674104018E-03 2.74027708160E-03 2.78434694890E-03 2.82942005816E-03 2.87490389737E-03 2.92136198397E-03 2.96846320090E-03 3.01625465493E-03 3.06501847962E-03 3.11447473634E-03 3.16459219264E-03 3.21567761341E-03 3.26750634306E-03 3.32027833143E-03 3.37378484980E-03 3.42819420978E-03 3.48347425066E-03 3.53970774935E-03 3.59682078697E-03 3.65488020219E-03 3.71372376981E-03 3.77362676048E-03 3.83458241546E-03 3.89638210392E-03 3.95917612400E-03 4.02315116076E-03 4.08790780542E-03 4.15391351454E-03 4.22094486825E-03 4.28907326872E-03 4.35812047601E-03 4.42842417872E-03 4.49992586397E-03 4.57251278627E-03 4.64626836235E-03 4.72114332995E-03 4.79735646954E-03 4.87469065651E-03 4.95331237312E-03 5.03324574525E-03 5.11439798359E-03 5.19682645700E-03 5.28062361741E-03 5.36591513433E-03 5.45230523839E-03 5.54036276010E-03 5.62977250561E-03 5.72048863546E-03 5.81278080450E-03 5.90647785342E-03 6.00179276502E-03 6.09862253490E-03 6.19702736735E-03 6.29685720282E-03 6.39839823039E-03 6.50163547937E-03 6.60659792642E-03 6.71308857990E-03 6.82141316446E-03 6.93143909264E-03 7.04315276903E-03 7.15683976333E-03 7.27214986396E-03 7.38946836730E-03 7.50867424447E-03 7.62985151226E-03 7.75282926405E-03 7.87799256751E-03 8.00501308163E-03 8.13413591365E-03 8.26522042943E-03 8.39860633014E-03 8.53412236468E-03 8.67175338790E-03 8.81153973447E-03 8.95368543081E-03 9.09815781081E-03 9.24483532158E-03 9.39397384885E-03 9.54545663795E-03 9.69942751448E-03 9.85590656166E-03 1.00148299563E-02 1.01763207644E-02 1.03405703422E-02 1.05072178221E-02 1.06767895912E-02 1.08488978055E-02 1.10239481710E-02 1.12017630984E-02 1.13823849489E-02 1.15660518823E-02 1.17525589356E-02 1.19420548121E-02 1.21348407707E-02 1.23304597439E-02 1.25292908516E-02 1.27314747790E-02 1.29367119162E-02 1.31453566649E-02 1.33575072015E-02 1.35727944995E-02 1.37916990758E-02 1.40141954109E-02 1.42402773273E-02 1.44699662837E-02 1.47033168918E-02 1.49404587848E-02 1.51814394259E-02 1.54264084360E-02 1.56750447415E-02 1.59279583283E-02 1.61848067350E-02 1.64458054594E-02 1.67111956671E-02 1.69807051525E-02 1.72545711768E-02 1.75328564984E-02 1.78156606492E-02 1.81029416756E-02 1.83949413511E-02 1.86917052167E-02 1.89930733998E-02 1.92994777740E-02 1.96107294409E-02 1.99269969308E-02 2.02484358956E-02 2.05750382800E-02 2.09069696488E-02 2.12441281119E-02 2.15867831858E-02 2.19348677183E-02 2.22887359008E-02 2.26481648624E-02 2.30135881175E-02 2.33846879122E-02 2.37618463615E-02 2.41451445814E-02 2.45345294322E-02 2.49303267365E-02 2.53323998926E-02 2.57410868977E-02 2.61560556831E-02 2.65781341452E-02 2.70066450231E-02 2.74422459657E-02 2.78847834313E-02 2.83346875340E-02 2.87916835214E-02 2.92559995916E-02 2.97278816717E-02 3.02074218734E-02 3.06945015104E-02 3.11895989455E-02 3.16928062978E-02 3.22039013978E-02 3.27233418716E-02 3.32511289951E-02 3.37874608137E-02 3.43323783970E-02 3.48861658339E-02 3.54488260859E-02 3.60206586263E-02 3.66015794920E-02 3.71919895843E-02 3.77918092504E-02 3.84013243352E-02 3.90207336856E-02 3.96501236442E-02 4.02896577456E-02 4.09394224570E-02 4.15997964297E-02 4.22707466577E-02 4.29524454900E-02 4.36453593988E-02 4.43492571991E-02 4.50647227870E-02 4.57914776192E-02 4.65300454776E-02 4.72805076345E-02 4.80431167026E-02 4.88180683021E-02 4.96054462886E-02 5.04055077223E-02 5.12185207255E-02 5.20446103156E-02 5.28840757615E-02 5.37371064177E-02 5.46039714047E-02 5.54844239774E-02 5.63795133273E-02 5.72888676205E-02 5.82128708199E-02 5.91518027304E-02 6.01058684686E-02 6.10753172286E-02 6.20604091266E-02 6.30614682138E-02 6.40785601523E-02 6.51121381533E-02 6.61624308082E-02 6.72294699630E-02 6.83138731240E-02 6.94157076912E-02 7.05353894231E-02 7.16730440062E-02 7.28291205362E-02 7.40038328689E-02 7.51974865058E-02 7.64103595607E-02 7.76428575205E-02 7.88952251494E-02 8.01677017691E-02 8.14607925920E-02 8.27747186226E-02 8.41098833303E-02 8.54665191373E-02 8.68449246588E-02 8.82458524379E-02 8.96691238771E-02 9.11154885200E-02 9.25850891573E-02 9.40786633280E-02 9.55959573944E-02 9.71378941572E-02 9.87047139760E-02 1.00296777833E-01 1.01914642894E-01 1.03558381847E-01 1.05228836798E-01 1.06926104530E-01 1.08650823882E-01 1.10403355144E-01 1.12184114601E-01 1.13993782574E-01 1.15832399471E-01 1.17700733438E-01 1.19599338379E-01 1.21528422982E-01 1.23488599638E-01 1.25480542881E-01 1.27504534439E-01 1.29561160521E-01 1.31650908439E-01 1.33774637514E-01 1.35932322860E-01 1.38125007798E-01 1.40352970350E-01 1.42616801893E-01 1.44917274649E-01 1.47254718483E-01 1.49630184737E-01 1.52043566606E-01 1.54496288654E-01 1.56988144355E-01 1.59520585897E-01 1.62093654696E-01 1.64708366329E-01 1.67365091992E-01 1.70064772000E-01 1.72808018909E-01 1.75595469314E-01 1.78427906690E-01 1.81306113015E-01 1.84230685351E-01 1.87202482524E-01 1.90222051902E-01 1.93290475128E-01 1.96408406505E-01 1.99576643688E-01 2.02795967379E-01 2.06067302311E-01 2.09391311605E-01 2.12769008764E-01 2.16201135096E-01 2.19688676507E-01 2.23232501133E-01 2.26833338245E-01 2.30492533834E-01 2.34210528880E-01 2.37988752089E-01 2.41827681118E-01 2.45728755667E-01 2.49692634804E-01 2.53720588807E-01 2.57813402959E-01 2.61972256661E-01 2.66198317712E-01 2.70492427864E-01 2.74855920413E-01 2.79289771067E-01 2.83795148638E-01 2.88373288456E-01 2.93025564959E-01 2.97748587769E-01 3.02561578705E-01 3.07433347604E-01 3.12394239414E-01 3.17437204117E-01 3.22559778158E-01 3.27749805631E-01 3.33060187063E-01 3.38406554952E-01 3.43890480003E-01 3.49424281875E-01 3.55061129792E-01 3.60791400563E-01 3.66622570221E-01 3.72518215012E-01 3.78537851761E-01 3.84641581951E-01 3.90854846983E-01 3.97152374529E-01 4.03559719362E-01 4.10070959966E-01 4.16689613207E-01 4.23413203665E-01 4.30238508561E-01 4.37187050931E-01 4.44231078452E-01 4.51403851750E-01 4.58690389657E-01 4.66081999971E-01 4.73605580013E-01 4.81243875495E-01 4.89012643968E-01 4.96901177369E-01 5.04917602752E-01 5.13058438537E-01 5.21347919776E-01 5.29751424819E-01 5.38296300500E-01 5.46990169811E-01 5.55803996422E-01 5.64786104856E-01 5.73881340156E-01 5.83156982798E-01 5.92555886780E-01 6.02120478084E-01 6.11836065005E-01 6.21704996675E-01 6.31738819784E-01 6.41931561602E-01 6.52289141324E-01 6.62815901820E-01 6.73512509459E-01 6.84370873359E-01 6.95423095817E-01 7.06640598517E-01 7.18042146452E-01 7.29633054796E-01 7.41401651825E-01 7.53368887461E-01 7.65520674706E-01 7.77879688263E-01 7.90428788901E-01 8.03182935222E-01 8.16148545431E-01 8.29314478508E-01 8.42697429645E-01 8.56300215108E-01 8.70114898256E-01 8.84158147225E-01 8.98426416905E-01 9.12924323320E-01 9.27658090486E-01 9.42631495591E-01 9.57839259315E-01 9.73301713864E-01 9.89006031116E-01 1.00497004897E+00 1.02118898675E+00 1.03766880057E+00 1.05441825352E+00 1.07143178671E+00 1.08873202227E+00 1.10629655315E+00 1.12415660798E+00 1.14230218879E+00 1.16073222633E+00 1.17947523589E+00 1.19850428656E+00 1.21786379290E+00 1.23750402831E+00 1.25749760690E+00 1.27777630767E+00 1.29841527016E+00 1.31937518585E+00 1.34065735095E+00 1.36232061499E+00 1.38429812591E+00 1.40664632660E+00 1.42935586324E+00 1.45242972389E+00 1.47587923839E+00 1.49970141594E+00 1.52391616583E+00 1.54851784859E+00 1.57351906765E+00 1.59891449392E+00 1.62474568434E+00 1.65096545133E+00 1.67762333974E+00 1.70471169381E+00 1.73223096920E+00 1.76021110503E+00 1.78862402939E+00 1.81750316435E+00 1.84685714172E+00 1.87666868931E+00 1.90699158487E+00 1.93775866348E+00 1.96907756847E+00 2.00085624389E+00 2.03318577921E+00 2.06600060655E+00 2.09937644721E+00 2.13328494662E+00 2.16772400140E+00 2.20274831776E+00 2.23831680864E+00 2.27447159911E+00 2.31120514039E+00 2.34854052635E+00 2.38646500572E+00 2.42501974842E+00 2.46419849395E+00 2.50398467086E+00 2.54445454457E+00 2.58554117743E+00 2.62731745335E+00 2.66976227671E+00 2.71288764734E+00 2.75672372705E+00 2.80125383420E+00 2.84651704327E+00 2.89250386260E+00 2.93924945438E+00 2.98672793725E+00 3.03500104726E+00 3.08403172666E+00 3.13387170199E+00 3.18451110009E+00 3.23598028494E+00 3.28827064137E+00 3.34141120938E+00 3.39541486932E+00 3.45029515175E+00 3.50605029136E+00 3.56272914573E+00 3.62031046610E+00 3.67883309742E+00 3.73829211150E+00 3.79872636549E+00 3.86013722780E+00 3.92253847809E+00 3.98595178377E+00 4.05039809588E+00 4.11587650420E+00 4.18243093935E+00 4.25005282372E+00 4.31877323982E+00 4.38861239847E+00 4.45957871249E+00 4.53169244084E+00 4.60497919686E+00 4.67945940121E+00 4.75513372083E+00 4.83204837869E+00 4.91020334930E+00 4.98962346474E+00 5.07033954398E+00 5.15235653506E+00 5.23570558697E+00 5.32041274084E+00 5.40648651780E+00 5.49396062625E+00 5.58285255253E+00 5.67318725708E+00 5.76498512795E+00 5.85827865847E+00 5.95307920368E+00 6.04942468023E+00 6.14732958777E+00 6.24682492415E+00 6.34793606823E+00 6.45068931162E+00 6.55511078375E+00 6.66122304803E+00 6.76906489171E+00 6.87865866467E+00 6.99002601322E+00 7.10320694678E+00 7.21822580731E+00 7.33511224573E+00 7.45389922374E+00 7.57461407887E+00 7.69729172970E+00 7.82196562150E+00 7.94866022414E+00 8.07741912229E+00 8.20826981460E+00 8.34124477576E+00 8.47638639503E+00 8.61372197843E+00 8.75329010636E+00 8.89513186811E+00 9.03927763126E+00 9.18576593518E+00 9.33464409388E+00 9.48593694453E+00 9.63969186908E+00 9.79595391853E+00 9.95475474111E+00 1.01161375713E+01 1.02801531703E+01 1.04468298352E+01 1.06162276114E+01 1.07883794260E+01 1.09633322068E+01 1.11411355694E+01 1.13218341335E+01 1.15054735804E+01 1.16921046978E+01 1.18817755500E+01 1.20745329357E+01 1.22704347313E+01 1.24695225302E+01 1.26718567357E+01 1.28774867394E+01 1.30864668642E+01 1.32988499273E+01 1.35146979074E+01 1.37340600215E+01 1.39569979786E+01 1.41835686804E+01 1.44138325161E+01 1.46478502267E+01 1.48856803619E+01 1.51273887021E+01 1.53730369634E+01 1.56226874340E+01 1.58764130897E+01 1.61342692019E+01 1.63963323966E+01 1.66626672448E+01 1.69333436061E+01 1.72084342345E+01 1.74880095498E+01 1.77721418366E+01 1.80609079482E+01 1.83543820179E+01 1.86526392678E+01 1.89557596444E+01 1.92638224344E+01 1.95769063608E+01 1.98950945067E+01 2.02184689279E+01 2.05471148903E+01 2.08811151179E+01 2.12205631557E+01 2.15655373976E+01 2.19161375915E+01 2.22724474839E+01 2.26345633179E+01 2.30025773934E+01 2.33765859486E+01 2.37566851242E+01 2.41429733292E+01 2.45355510451E+01 2.49345174940E+01 2.53399801667E+01 2.57520359046E+01 2.61707985714E+01 2.65963706757E+01 2.70288624119E+01 2.74683868567E+01 2.79150522792E+01 2.83689764741E+01 2.88302729260E+01 2.92990605426E+01 2.97754553185E+01 3.02595839816E+01 3.07515616368E+01 3.12515189320E+01 3.17595765265E+01 3.22758684032E+01 3.28005162502E+01 3.33336595314E+01 3.38754244640E+01 3.44259500245E+01 3.49853721947E+01 3.55538279621E+01 3.61314595174E+01 3.67184079949E+01 3.73148175498E+01 3.79208338184E+01 3.85366052718E+01 3.91622798094E+01 3.97980106290E+01 4.04439493191E+01 4.11002519656E+01 4.17670736903E+01 4.24445755408E+01 4.31329151831E+01 4.38322567587E+01 4.45427623422E+01 4.52646005806E+01 4.59979344794E+01 4.67429373599E+01 4.74997763600E+01 4.82686271911E+01 4.90496601349E+01 4.98430541366E+01 5.06489848683E+01 5.14676296362E+01 5.22991706598E+01 5.31437880267E+01 5.40016647392E+01 5.48729849928E+01 5.57579336472E+01 5.66566973086E+01 5.75694632747E+01 5.84964200143E+01 5.94377567369E+01 6.03936642385E+01 6.13643318096E+01 6.23499525583E+01 6.33507171443E+01 6.43668190106E+01 6.53984492802E+01 6.64458015569E+01 6.75090685022E+01 6.85884417956E+01 6.96841141619E+01 7.07962767776E+01 7.19251206828E+01 7.30708357887E+01 7.42336108961E+01 7.54136334748E+01 7.66110903139E+01 7.78261639818E+01 7.90590392127E+01 8.03098934197E+01 8.15789064132E+01 8.28662510977E+01 8.41720996385E+01 8.54966207384E+01 8.68399771986E+01 8.82023307369E+01 8.95838358374E+01 9.09846436057E+01 9.24049000960E+01 9.38447440981E+01 9.53043098280E+01 9.67837239424E+01 9.82831071404E+01 9.98025706274E+01 1.01342219108E+02 1.02902148594E+02 1.04482444251E+02 1.06083184005E+02 1.07704432214E+02 1.09346245421E+02 1.11008665224E+02 1.12691723570E+02 1.14395436816E+02 1.16119809338E+02 1.17864829213E+02 1.19630469963E+02 1.21416688269E+02 1.23223423223E+02 1.25050596428E+02 1.26898109985E+02 1.28765845317E+02 1.30653663845E+02 1.32561403705E+02 1.34488880147E+02 1.36435884245E+02 1.38402181185E+02 1.40387509474E+02 1.42391579442E+02 1.44414072484E+02 1.46454639225E+02 1.48512898251E+02 1.50588434592E+02 1.52680799421E+02 1.54789506709E+02 1.56914032573E+02 1.59053815130E+02 1.61208250134E+02 1.63376691668E+02 1.65558449480E+02 1.67752787102E+02 1.69958921169E+02 1.72176017925E+02 1.74403193416E+02 1.76639510138E+02 1.78883975355E+02 1.81135540759E+02 1.83393097583E+02 1.85655477625E+02 1.87921449862E+02 1.90189718004E+02 1.92458919887E+02 1.94727623516E+02 1.96994327672E+02 1.99257456831E+02 2.01515361919E+02 2.03766315713E+02 2.06008513626E+02 2.08240068394E+02 2.10459011395E+02 2.12663288125E+02 2.14850758038E+02 2.17019190641E+02 2.19166266594E+02 2.21289572641E+02 2.23386602505E+02 2.25454753738E+02 2.27491326617E+02 2.29493523377E+02 2.31458445254E+02 2.33383092932E+02 2.35264364778E+02 2.37099055739E+02 2.38883856597E+02 2.40615353937E+02 2.42290029243E+02 2.43904258872E+02 2.45454314157E+02 2.46936361863E+02 2.48346464160E+02 2.49680580730E+02 2.50934568563E+02 2.52104184047E+02 2.53185085670E+02 2.54172835100E+02 2.55062899652E+02 2.55850657188E+02 2.56531397685E+02 2.57100328126E+02 2.57552576920E+02 2.57883199748E+02 2.58087183053E+02 2.58159453461E+02 2.58094880706E+02 2.57888289264E+02 2.57534462742E+02 2.57028155856E+02 2.56364101408E+02 2.55537023228E+02 2.54541644688E+02 2.53372702914E+02 2.52024960521E+02 2.50493219359E+02 2.48772335120E+02 2.46857233712E+02 2.44742926262E+02 2.42424528089E+02 2.39897276162E+02 2.37156548759E+02 2.34197886692E+02 2.31017013211E+02 2.27609858367E+02 2.23972581584E+02 2.20101596440E+02 2.15993596447E+02 2.11645581965E+02 2.07054887346E+02 2.02219210350E+02 1.97136641239E+02 1.91805694345E+02 1.86225338042E+02 1.80395028452E+02 1.74314742190E+02 1.67985009219E+02 1.61406949103E+02 1.54582304129E+02 1.47513475850E+02 1.40203560333E+02 1.32656383446E+02 1.24876538244E+02 1.16869418758E+02 1.08641256665E+02 1.00199155583E+02 9.15511253290E+01 8.27061148239E+01 7.36740442233E+01 6.44658346408E+01 5.50934377662E+01 4.55698604740E+01 3.59091903859E+01 2.61266156027E+01 1.62384425873E+01 6.26210990672E+00 -3.78380170436E+00 -1.38795652463E+01 -2.40043074786E+01 -3.41360145380E+01 -4.42515453482E+01 -5.43266508439E+01 -6.43360013558E+01 -7.42532214258E+01 -8.40509357225E+01 -9.37008223263E+01 -1.03173678119E+02 -1.12439494682E+02 -1.21467547299E+02 -1.30226494656E+02 -1.38684495160E+02 -1.46809334525E+02 -1.54568571220E+02 -1.61929695702E+02 -1.68860307507E+02 -1.75328308167E+02 -1.81302112995E+02 -1.86750879116E+02 -1.91644753248E+02 -1.95955135842E+02 -1.99654964171E+02 -2.02719011955E+02 -2.05124204937E+02 -2.06849952682E+02 -2.07878491810E+02 -2.08195241148E+02 -2.07789163932E+02 -2.06653133619E+02 -2.04784299109E+02 -2.02184442929E+02 -1.98860324556E+02 -1.94824002435E+02 -1.90093122040E+02 -1.84691160043E+02 -1.78647608732E+02 -1.71998085733E+02 -1.64784347580E+02 -1.57054186864E+02 -1.48861184429E+02 -1.40264288334E+02 -1.31327182421E+02 -1.22117406459E+02 -1.12705179485E+02 -1.03161873782E+02 -9.35580789810E+01 -8.39611848447E+01 -7.44324046221E+01 -6.50231454312E+01 -5.57706232039E+01 -4.66926011334E+01 -3.77811173677E+01 -2.89950472145E+01 -2.02787905470E+01 -1.16549556347E+01 -3.17180184758E+00 5.11962266303E+00 1.31654408409E+01 2.09089137806E+01 2.82904159893E+01 3.52474185457E+01 4.17144827320E+01 4.76232630926E+01 5.29025228497E+01 5.74781612207E+01 6.12732542452E+01 6.42081101533E+01 6.62003403073E+01 6.71649468513E+01 6.70144287739E+01 6.56589061929E+01 6.30062657556E+01 5.89623300781E+01 5.34310188211E+01 4.63148436681E+01 3.75123986787E+01 2.69455124509E+01 1.42965714317E+01 1.58093297783E+00 -1.57801632286E-01 1.57510497812E-02 -1.57219541372E-03 1.56926652830E-04 -1.56548699445E-05 1.56411732410E-06 -1.53111597938E-07 1.56952309239E-08 -5.02967136298E-09 6.57891401367E-10 6 Number of nonzero Dij 1 1 5.36819853577E-01 1 2 -3.94160402748E-01 2 2 2.91320688005E-01 3 3 3.81189126895E-01 3 4 3.36875808536E-01 4 4 2.97359374367E-01 0 nqf. If not zero, Qij's inside rinner are computed using qfcoef's 1 1 0 i j (l(j)) -1.45393703561E-01 Q_int -2.03195665890E-06 -2.06472936851E-06 -2.09803065623E-06 -2.13186904725E-06 -2.16625320426E-06 -2.20119192966E-06 -2.23669416781E-06 -2.27276900732E-06 -2.30942568342E-06 -2.34667358026E-06 -2.38452223335E-06 -2.42298133197E-06 -2.46206072172E-06 -2.50177040694E-06 -2.54212055336E-06 -2.58312149065E-06 -2.62478371508E-06 -2.66711789221E-06 -2.71013485962E-06 -2.75384562967E-06 -2.79826139235E-06 -2.84339351811E-06 -2.88925356079E-06 -2.93585326057E-06 -2.98320454698E-06 -3.03131954195E-06 -3.08021056293E-06 -3.12989012600E-06 -3.18037094913E-06 -3.23166595540E-06 -3.28378827631E-06 -3.33675125514E-06 -3.39056845040E-06 -3.44525363924E-06 -3.50082082103E-06 -3.55728422093E-06 -3.61465829352E-06 -3.67295772648E-06 -3.73219744442E-06 -3.79239261262E-06 -3.85355864096E-06 -3.91571118786E-06 -3.97886616427E-06 -4.04303973774E-06 -4.10824833661E-06 -4.17450865414E-06 -4.24183765284E-06 -4.31025256879E-06 -4.37977091604E-06 -4.45041049112E-06 -4.52218937758E-06 -4.59512595062E-06 -4.66923888181E-06 -4.74454714382E-06 -4.82107001534E-06 -4.89882708599E-06 -4.97783826130E-06 -5.05812376786E-06 -5.13970415847E-06 -5.22260031738E-06 -5.30683346571E-06 -5.39242516677E-06 -5.47939733168E-06 -5.56777222494E-06 -5.65757247011E-06 -5.74882105562E-06 -5.84154134066E-06 -5.93575706117E-06 -6.03149233586E-06 -6.12877167245E-06 -6.22761997390E-06 -6.32806254482E-06 -6.43012509789E-06 -6.53383376051E-06 -6.63921508144E-06 -6.74629603760E-06 -6.85510404101E-06 -6.96566694576E-06 -7.07801305518E-06 -7.19217112903E-06 -7.30817039094E-06 -7.42604053582E-06 -7.54581173749E-06 -7.66751465639E-06 -7.79118044747E-06 -7.91684076809E-06 -8.04452778619E-06 -8.17427418850E-06 -8.30611318888E-06 -8.44007853687E-06 -8.57620452628E-06 -8.71452600401E-06 -8.85507837893E-06 -8.99789763098E-06 -9.14302032034E-06 -9.29048359683E-06 -9.44032520937E-06 -9.59258351568E-06 -9.74729749209E-06 -9.90450674349E-06 -1.00642515135E-05 -1.02265726948E-05 -1.03915118394E-05 -1.05591111696E-05 -1.07294135886E-05 -1.09024626914E-05 -1.10783027761E-05 -1.12569788551E-05 -1.14385366671E-05 -1.16230226879E-05 -1.18104841431E-05 -1.20009690200E-05 -1.21945260795E-05 -1.23912048690E-05 -1.25910557351E-05 -1.27941298360E-05 -1.30004791552E-05 -1.32101565144E-05 -1.34232155871E-05 -1.36397109124E-05 -1.38596979091E-05 -1.40832328894E-05 -1.43103730740E-05 -1.45411766060E-05 -1.47757025663E-05 -1.50140109887E-05 -1.52561628748E-05 -1.55022202104E-05 -1.57522459805E-05 -1.60063041859E-05 -1.62644598596E-05 -1.65267790834E-05 -1.67933290045E-05 -1.70641778531E-05 -1.73393949596E-05 -1.76190507725E-05 -1.79032168764E-05 -1.81919660101E-05 -1.84853720855E-05 -1.87835102064E-05 -1.90864566876E-05 -1.93942890748E-05 -1.97070861638E-05 -2.00249280213E-05 -2.03478960052E-05 -2.06760727850E-05 -2.10095423637E-05 -2.13483900986E-05 -2.16927027234E-05 -2.20425683708E-05 -2.23980765942E-05 -2.27593183913E-05 -2.31263862272E-05 -2.34993740579E-05 -2.38783773546E-05 -2.42634931278E-05 -2.46548199523E-05 -2.50524579927E-05 -2.54565090284E-05 -2.58670764802E-05 -2.62842654363E-05 -2.67081826798E-05 -2.71389367151E-05 -2.75766377967E-05 -2.80213979567E-05 -2.84733310335E-05 -2.89325527014E-05 -2.93991804995E-05 -2.98733338624E-05 -3.03551341504E-05 -3.08447046806E-05 -3.13421707584E-05 -3.18476597099E-05 -3.23613009138E-05 -3.28832258351E-05 -3.34135680585E-05 -3.39524633225E-05 -3.45000495543E-05 -3.50564669047E-05 -3.56218577846E-05 -3.61963669007E-05 -3.67801412929E-05 -3.73733303719E-05 -3.79760859574E-05 -3.85885623168E-05 -3.92109162048E-05 -3.98433069033E-05 -4.04858962622E-05 -4.11388487411E-05 -4.18023314509E-05 -4.24765141967E-05 -4.31615695213E-05 -4.38576727493E-05 -4.45650020318E-05 -4.52837383921E-05 -4.60140657718E-05 -4.67561710782E-05 -4.75102442316E-05 -4.82764782142E-05 -4.90550691194E-05 -4.98462162018E-05 -5.06501219281E-05 -5.14669920292E-05 -5.22970355524E-05 -5.31404649149E-05 -5.39974959586E-05 -5.48683480045E-05 -5.57532439091E-05 -5.66524101218E-05 -5.75660767420E-05 -5.84944775785E-05 -5.94378502088E-05 -6.03964360405E-05 -6.13704803722E-05 -6.23602324567E-05 -6.33659455645E-05 -6.43878770488E-05 -6.54262884107E-05 -6.64814453667E-05 -6.75536179161E-05 -6.86430804102E-05 -6.97501116224E-05 -7.08749948194E-05 -7.20180178336E-05 -7.31794731364E-05 -7.43596579135E-05 -7.55588741402E-05 -7.67774286588E-05 -7.80156332571E-05 -7.92738047479E-05 -8.05522650500E-05 -8.18513412704E-05 -8.31713657876E-05 -8.45126763371E-05 -8.58756160971E-05 -8.72605337763E-05 -8.86677837032E-05 -9.00977259162E-05 -9.15507262557E-05 -9.30271564577E-05 -9.45273942485E-05 -9.60518234412E-05 -9.76008340337E-05 -9.91748223082E-05 -1.00774190933E-04 -1.02399349063E-04 -1.04050712449E-04 -1.05728703538E-04 -1.07433751584E-04 -1.09166292759E-04 -1.10926770260E-04 -1.12715634429E-04 -1.14533342859E-04 -1.16380360518E-04 -1.18257159865E-04 -1.20164220969E-04 -1.22102031636E-04 -1.24071087528E-04 -1.26071892293E-04 -1.28104957694E-04 -1.30170803734E-04 -1.32269958798E-04 -1.34402959778E-04 -1.36570352218E-04 -1.38772690447E-04 -1.41010537724E-04 -1.43284466380E-04 -1.45595057966E-04 -1.47942903398E-04 -1.50328603110E-04 -1.52752767207E-04 -1.55216015619E-04 -1.57718978262E-04 -1.60262295195E-04 -1.62846616784E-04 -1.65472603871E-04 -1.68140927937E-04 -1.70852271279E-04 -1.73607327179E-04 -1.76406800081E-04 -1.79251405776E-04 -1.82141871577E-04 -1.85078936507E-04 -1.88063351491E-04 -1.91095879542E-04 -1.94177295955E-04 -1.97308388512E-04 -2.00489957672E-04 -2.03722816783E-04 -2.07007792285E-04 -2.10345723922E-04 -2.13737464954E-04 -2.17183882377E-04 -2.20685857140E-04 -2.24244284373E-04 -2.27860073610E-04 -2.31534149025E-04 -2.35267449667E-04 -2.39060929693E-04 -2.42915558617E-04 -2.46832321554E-04 -2.50812219470E-04 -2.54856269438E-04 -2.58965504895E-04 -2.63140975906E-04 -2.67383749429E-04 -2.71694909588E-04 -2.76075557948E-04 -2.80526813793E-04 -2.85049814415E-04 -2.89645715395E-04 -2.94315690906E-04 -2.99060934003E-04 -3.03882656930E-04 -3.08782091428E-04 -3.13760489046E-04 -3.18819121456E-04 -3.23959280784E-04 -3.29182279929E-04 -3.34489452901E-04 -3.39882155157E-04 -3.45361763946E-04 -3.50929678658E-04 -3.56587321179E-04 -3.62336136249E-04 -3.68177591834E-04 -3.74113179489E-04 -3.80144414745E-04 -3.86272837486E-04 -3.92500012345E-04 -3.98827529093E-04 -4.05257003048E-04 -4.11790075481E-04 -4.18428414030E-04 -4.25173713125E-04 -4.32027694415E-04 -4.38992107203E-04 -4.46068728890E-04 -4.53259365422E-04 -4.60565851749E-04 -4.67990052286E-04 -4.75533861387E-04 -4.83199203822E-04 -4.90988035262E-04 -4.98902342775E-04 -5.06944145326E-04 -5.15115494289E-04 -5.23418473959E-04 -5.31855202086E-04 -5.40427830402E-04 -5.49138545166E-04 -5.57989567717E-04 -5.66983155030E-04 -5.76121600288E-04 -5.85407233459E-04 -5.94842421881E-04 -6.04429570860E-04 -6.14171124272E-04 -6.24069565183E-04 -6.34127416470E-04 -6.44347241456E-04 -6.54731644556E-04 -6.65283271928E-04 -6.76004812141E-04 -6.86898996851E-04 -6.97968601482E-04 -7.09216445929E-04 -7.20645395260E-04 -7.32258360438E-04 -7.44058299051E-04 -7.56048216050E-04 -7.68231164506E-04 -7.80610246373E-04 -7.93188613265E-04 -8.05969467243E-04 -8.18956061621E-04 -8.32151701775E-04 -8.45559745970E-04 -8.59183606203E-04 -8.73026749052E-04 -8.87092696540E-04 -9.01385027022E-04 -9.15907376068E-04 -9.30663437377E-04 -9.45656963695E-04 -9.60891767751E-04 -9.76371723205E-04 -9.92100765615E-04 -1.00808289341E-03 -1.02432216891E-03 -1.04082271928E-03 -1.05758873763E-03 -1.07462448399E-03 -1.09193428641E-03 -1.10952254201E-03 -1.12739371809E-03 -1.14555235323E-03 -1.16400305839E-03 -1.18275051810E-03 -1.20179949158E-03 -1.22115481392E-03 -1.24082139731E-03 -1.26080423221E-03 -1.28110838861E-03 -1.30173901727E-03 -1.32270135098E-03 -1.34400070588E-03 -1.36564248273E-03 -1.38763216830E-03 -1.40997533663E-03 -1.43267765048E-03 -1.45574486268E-03 -1.47918281757E-03 -1.50299745239E-03 -1.52719479878E-03 -1.55178098424E-03 -1.57676223362E-03 -1.60214487065E-03 -1.62793531950E-03 -1.65414010633E-03 -1.68076586088E-03 -1.70781931810E-03 -1.73530731980E-03 -1.76323681626E-03 -1.79161486800E-03 -1.82044864745E-03 -1.84974544068E-03 -1.87951264919E-03 -1.90975779170E-03 -1.94048850599E-03 -1.97171255068E-03 -2.00343780719E-03 -2.03567228158E-03 -2.06842410651E-03 -2.10170154320E-03 -2.13551298341E-03 -2.16986695144E-03 -2.20477210621E-03 -2.24023724333E-03 -2.27627129718E-03 -2.31288334309E-03 -2.35008259946E-03 -2.38787843002E-03 -2.42628034601E-03 -2.46529800848E-03 -2.50494123057E-03 -2.54521997985E-03 -2.58614438070E-03 -2.62772471666E-03 -2.66997143292E-03 -2.71289513877E-03 -2.75650661009E-03 -2.80081679189E-03 -2.84583680093E-03 -2.89157792826E-03 -2.93805164192E-03 -2.98526958964E-03 -3.03324360152E-03 -3.08198569280E-03 -3.13150806671E-03 -3.18182311724E-03 -3.23294343209E-03 -3.28488179553E-03 -3.33765119143E-03 -3.39126480617E-03 -3.44573603179E-03 -3.50107846897E-03 -3.55730593025E-03 -3.61443244314E-03 -3.67247225335E-03 -3.73143982806E-03 -3.79134985920E-03 -3.85221726682E-03 -3.91405720245E-03 -3.97688505257E-03 -4.04071644205E-03 -4.10556723771E-03 -4.17145355188E-03 -4.23839174603E-03 -4.30639843443E-03 -4.37549048785E-03 -4.44568503736E-03 -4.51699947811E-03 -4.58945147320E-03 -4.66305895761E-03 -4.73784014212E-03 -4.81381351735E-03 -4.89099785781E-03 -4.96941222602E-03 -5.04907597667E-03 -5.13000876079E-03 -5.21223053009E-03 -5.29576154123E-03 -5.38062236017E-03 -5.46683386665E-03 -5.55441725862E-03 -5.64339405677E-03 -5.73378610911E-03 -5.82561559564E-03 -5.91890503299E-03 -6.01367727916E-03 -6.10995553837E-03 -6.20776336584E-03 -6.30712467274E-03 -6.40806373113E-03 -6.51060517896E-03 -6.61477402516E-03 -6.72059565475E-03 -6.82809583400E-03 -6.93730071566E-03 -7.04823684429E-03 -7.16093116152E-03 -7.27541101150E-03 -7.39170414632E-03 -7.50983873150E-03 -7.62984335157E-03 -7.75174701564E-03 -7.87557916309E-03 -8.00136966923E-03 -8.12914885112E-03 -8.25894747334E-03 -8.39079675387E-03 -8.52472836999E-03 -8.66077446425E-03 -8.79896765047E-03 -8.93934101983E-03 -9.08192814693E-03 -9.22676309598E-03 -9.37388042696E-03 -9.52331520192E-03 -9.67510299118E-03 -9.82927987975E-03 -9.98588247361E-03 -1.01449479062E-02 -1.03065138447E-02 -1.04706184969E-02 -1.06373006171E-02 -1.08065995132E-02 -1.09785550532E-02 -1.11532076714E-02 -1.13305983755E-02 -1.15107687531E-02 -1.16937609782E-02 -1.18796178184E-02 -1.20683826409E-02 -1.22600994199E-02 -1.24548127431E-02 -1.26525678181E-02 -1.28534104798E-02 -1.30573871969E-02 -1.32645450783E-02 -1.34749318806E-02 -1.36885960140E-02 -1.39055865499E-02 -1.41259532269E-02 -1.43497464580E-02 -1.45770173369E-02 -1.48078176451E-02 -1.50421998579E-02 -1.52802171517E-02 -1.55219234099E-02 -1.57673732298E-02 -1.60166219286E-02 -1.62697255503E-02 -1.65267408715E-02 -1.67877254080E-02 -1.70527374206E-02 -1.73218359213E-02 -1.75950806792E-02 -1.78725322264E-02 -1.81542518637E-02 -1.84403016661E-02 -1.87307444883E-02 -1.90256439701E-02 -1.93250645416E-02 -1.96290714279E-02 -1.99377306545E-02 -2.02511090512E-02 -2.05692742574E-02 -2.08922947255E-02 -2.12202397258E-02 -2.15531793495E-02 -2.18911845128E-02 -2.22343269601E-02 -2.25826792668E-02 -2.29363148422E-02 -2.32953079320E-02 -2.36597336204E-02 -2.40296678317E-02 -2.44051873319E-02 -2.47863697297E-02 -2.51732934773E-02 -2.55660378705E-02 -2.59646830485E-02 -2.63693099935E-02 -2.67800005293E-02 -2.71968373200E-02 -2.76199038679E-02 -2.80492845107E-02 -2.84850644184E-02 -2.89273295893E-02 -2.93761668460E-02 -2.98316638302E-02 -3.02939089966E-02 -3.07629916072E-02 -3.12390017235E-02 -3.17220301989E-02 -3.22121686699E-02 -3.27095095467E-02 -3.32141460027E-02 -3.37261719631E-02 -3.42456820931E-02 -3.47727717840E-02 -3.53075371396E-02 -3.58500749608E-02 -3.64004827289E-02 -3.69588585886E-02 -3.75253013290E-02 -3.80999103639E-02 -3.86827857102E-02 -3.92740279661E-02 -3.98737382864E-02 -4.04820183579E-02 -4.10989703723E-02 -4.17246969978E-02 -4.23593013492E-02 -4.30028869567E-02 -4.36555577321E-02 -4.43174179342E-02 -4.49885721314E-02 -4.56691251636E-02 -4.63591821007E-02 -4.70588482006E-02 -4.77682288636E-02 -4.84874295856E-02 -4.92165559089E-02 -4.99557133704E-02 -5.07050074473E-02 -5.14645435009E-02 -5.22344267173E-02 -5.30147620455E-02 -5.38056541329E-02 -5.46072072580E-02 -5.54195252599E-02 -5.62427114650E-02 -5.70768686106E-02 -5.79220987653E-02 -5.87785032458E-02 -5.96461825305E-02 -6.05252361699E-02 -6.14157626927E-02 -6.23178595086E-02 -6.32316228072E-02 -6.41571474532E-02 -6.50945268766E-02 -6.60438529602E-02 -6.70052159212E-02 -6.79787041897E-02 -6.89644042821E-02 -6.99624006694E-02 -7.09727756417E-02 -7.19956091670E-02 -7.30309787454E-02 -7.40789592579E-02 -7.51396228099E-02 -7.62130385697E-02 -7.72992726006E-02 -7.83983876886E-02 -7.95104431629E-02 -8.06354947115E-02 -8.17735941904E-02 -8.29247894263E-02 -8.40891240137E-02 -8.52666371046E-02 -8.64573631927E-02 -8.76613318902E-02 -8.88785676979E-02 -9.01090897685E-02 -9.13529116629E-02 -9.26100410993E-02 -9.38804796949E-02 -9.51642227005E-02 -9.64612587277E-02 -9.77715694679E-02 -9.90951294047E-02 -1.00431905518E-01 -1.01781856980E-01 -1.03144934845E-01 -1.04521081729E-01 -1.05910231482E-01 -1.07312308854E-01 -1.08727229153E-01 -1.10154897893E-01 -1.11595210433E-01 -1.13048051614E-01 -1.14513295382E-01 -1.15990804405E-01 -1.17480429686E-01 -1.18982010161E-01 -1.20495372298E-01 -1.22020329682E-01 -1.23556682596E-01 -1.25104217593E-01 -1.26662707064E-01 -1.28231908800E-01 -1.29811565543E-01 -1.31401404535E-01 -1.33001137062E-01 -1.34610457988E-01 -1.36229045295E-01 -1.37856559604E-01 -1.39492643706E-01 -1.41136922079E-01 -1.42789000413E-01 -1.44448465124E-01 -1.46114882872E-01 -1.47787800078E-01 -1.49466742439E-01 -1.51151214448E-01 -1.52840698915E-01 -1.54534656490E-01 -1.56232525191E-01 -1.57933719939E-01 -1.59637632098E-01 -1.61343629026E-01 -1.63051053631E-01 -1.64759223941E-01 -1.66467432686E-01 -1.68174946894E-01 -1.69881007502E-01 -1.71584828987E-01 -1.73285599009E-01 -1.74982478087E-01 -1.76674599289E-01 -1.78361067951E-01 -1.80040961423E-01 -1.81713328847E-01 -1.83377190963E-01 -1.85031539956E-01 -1.86675339335E-01 -1.88307523858E-01 -1.89926999492E-01 -1.91532643427E-01 -1.93123304136E-01 -1.94697801484E-01 -1.96254926899E-01 -1.97793443592E-01 -1.99312086845E-01 -2.00809564366E-01 -2.02284556701E-01 -2.03735717736E-01 -2.05161675251E-01 -2.06561031578E-01 -2.07932364319E-01 -2.09274227164E-01 -2.10585150794E-01 -2.11863643876E-01 -2.13108194157E-01 -2.14317269655E-01 -2.15489319957E-01 -2.16622777622E-01 -2.17716059695E-01 -2.18767569331E-01 -2.19775697543E-01 -2.20738825060E-01 -2.21655324314E-01 -2.22523561549E-01 -2.23341899054E-01 -2.24108697531E-01 -2.24822318584E-01 -2.25481127349E-01 -2.26083495250E-01 -2.26627802890E-01 -2.27112443077E-01 -2.27535823977E-01 -2.27896372407E-01 -2.28192537250E-01 -2.28422793007E-01 -2.28585643464E-01 -2.28679625489E-01 -2.28703312948E-01 -2.28655320726E-01 -2.28534308865E-01 -2.28338986797E-01 -2.28068117672E-01 -2.27720522774E-01 -2.27295086009E-01 -2.26790758461E-01 -2.26206563004E-01 -2.25541598953E-01 -2.24795046745E-01 -2.23966172640E-01 -2.23054333409E-01 -2.22058981012E-01 -2.20979667244E-01 -2.19816048315E-01 -2.18567889362E-01 -2.17235068867E-01 -2.15817582949E-01 -2.14315549521E-01 -2.12729212277E-01 -2.11058944489E-01 -2.09305252588E-01 -2.07468779496E-01 -2.05550307688E-01 -2.03550761958E-01 -2.01471211848E-01 -1.99312873725E-01 -1.97077112469E-01 -1.94765442738E-01 -1.92379529800E-01 -1.89921189877E-01 -1.87392389995E-01 -1.84795247296E-01 -1.82132027802E-01 -1.79405144587E-01 -1.76617155348E-01 -1.73770759348E-01 -1.70868793712E-01 -1.67914229052E-01 -1.64910164418E-01 -1.61859821560E-01 -1.58766538477E-01 -1.55633762279E-01 -1.52465041332E-01 -1.49264016703E-01 -1.46034412923E-01 -1.42780028054E-01 -1.39504723113E-01 -1.36212410849E-01 -1.32907043917E-01 -1.29592602491E-01 -1.26273081336E-01 -1.22952476419E-01 -1.19634771089E-01 -1.16323921902E-01 -1.13023844162E-01 -1.09738397241E-01 -1.06471369780E-01 -1.03226464847E-01 -1.00007285153E-01 -9.68173184324E-02 -9.36599230917E-02 -9.05383142439E-02 -8.74555502482E-02 -8.44145198803E-02 -8.14179302609E-02 -7.84682956766E-02 -7.55679274263E-02 -7.27189248315E-02 -6.99231675486E-02 -6.71823093202E-02 -6.44977733037E-02 -6.18707491115E-02 -5.93021916948E-02 -5.67928221982E-02 -5.43431309072E-02 -5.19533824020E-02 -4.96236230250E-02 -4.73536907572E-02 -4.51432275893E-02 -4.29916944597E-02 -4.08983888176E-02 -3.88624648538E-02 -3.68829564244E-02 -3.49588026753E-02 -3.30888763518E-02 -3.12720147608E-02 -2.95070533241E-02 -2.77928616405E-02 -2.61283819455E-02 -2.45126698300E-02 -2.29449370462E-02 -2.14245962025E-02 -1.99513071077E-02 -1.85250244948E-02 -1.71460468129E-02 -1.58150657367E-02 -1.45332159995E-02 -1.33021251120E-02 -1.21239624801E-02 -1.10014873874E-02 -9.93809525558E-03 -8.93696102510E-03 -7.99809831940E-03 -7.12058929099E-03 -6.30341415512E-03 -5.54544817302E-03 -4.84545844929E-03 -4.20210054508E-03 -3.61391491065E-03 -3.07932314312E-03 -2.59662407743E-03 -2.16398972108E-03 -1.77946104603E-03 -1.44094365396E-03 -1.14620333427E-03 -8.92861537522E-04 -6.78390790872E-04 -5.00110085501E-04 -3.55180270628E-04 -2.40599492806E-04 -1.53198724024E-04 -8.96374271676E-05 -4.63994126643E-05 -1.97889458497E-05 -5.92717057416E-06 -7.48920968323E-07 -1.98416076451E-16 4.27643310979E-17 -8.66816199108E-18 -4.44488910631E-17 -3.62657457436E-19 1.75144596428E-16 -2.22198532138E-17 -3.37309099042E-18 8.73325021443E-18 -1.75018031824E-17 5.48319212726E-18 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1 2 0 i j (l(j)) 1.11691911854E-01 Q_int 1.65159830614E-06 1.67823634697E-06 1.70530402214E-06 1.73280826103E-06 1.76075610475E-06 1.78915470800E-06 1.81801134084E-06 1.84733339061E-06 1.87712836380E-06 1.90740388794E-06 1.93816771360E-06 1.96942771635E-06 2.00119189878E-06 2.03346839253E-06 2.06626546042E-06 2.09959149852E-06 2.13345503830E-06 2.16786474886E-06 2.20282943909E-06 2.23835805996E-06 2.27445970680E-06 2.31114362165E-06 2.34841919559E-06 2.38629597115E-06 2.42478364481E-06 2.46389206938E-06 2.50363125661E-06 2.54401137972E-06 2.58504277601E-06 2.62673594948E-06 2.66910157355E-06 2.71215049380E-06 2.75589373072E-06 2.80034248251E-06 2.84550812803E-06 2.89140222961E-06 2.93803653609E-06 2.98542298578E-06 3.03357370955E-06 3.08250103390E-06 3.13221748414E-06 3.18273578758E-06 3.23406887681E-06 3.28622989301E-06 3.33923218925E-06 3.39308933403E-06 3.44781511461E-06 3.50342354068E-06 3.55992884782E-06 3.61734550123E-06 3.67568819941E-06 3.73497187791E-06 3.79521171314E-06 3.85642312631E-06 3.91862178731E-06 3.98182361877E-06 4.04604480012E-06 4.11130177172E-06 4.17761123908E-06 4.24499017715E-06 4.31345583463E-06 4.38302573840E-06 4.45371769803E-06 4.52554981032E-06 4.59854046391E-06 4.67270834402E-06 4.74807243723E-06 4.82465203631E-06 4.90246674520E-06 4.98153648400E-06 5.06188149406E-06 5.14352234320E-06 5.22647993094E-06 5.31077549385E-06 5.39643061102E-06 5.48346720954E-06 5.57190757013E-06 5.66177433286E-06 5.75309050293E-06 5.84587945653E-06 5.94016494687E-06 6.03597111026E-06 6.13332247222E-06 6.23224395386E-06 6.33276087815E-06 6.43489897651E-06 6.53868439528E-06 6.64414370253E-06 6.75130389477E-06 6.86019240390E-06 6.97083710422E-06 7.08326631958E-06 7.19750883061E-06 7.31359388209E-06 7.43155119043E-06 7.55141095130E-06 7.67320384734E-06 7.79696105600E-06 7.92271425755E-06 8.05049564316E-06 8.18033792315E-06 8.31227433537E-06 8.44633865370E-06 8.58256519668E-06 8.72098883632E-06 8.86164500699E-06 9.00456971453E-06 9.14979954542E-06 9.29737167619E-06 9.44732388290E-06 9.59969455082E-06 9.75452268424E-06 9.91184791647E-06 1.00717105200E-05 1.02341514167E-05 1.03992121885E-05 1.05669350879E-05 1.07373630485E-05 1.09105396968E-05 1.10865093623E-05 1.12653170897E-05 1.14470086502E-05 1.16316305527E-05 1.18192300566E-05 1.20098551831E-05 1.22035547279E-05 1.24003782736E-05 1.26003762025E-05 1.28035997092E-05 1.30101008140E-05 1.32199323758E-05 1.34331481064E-05 1.36498025833E-05 1.38699512644E-05 1.40936505018E-05 1.43209575564E-05 1.45519306123E-05 1.47866287920E-05 1.50251121716E-05 1.52674417955E-05 1.55136796929E-05 1.57638888930E-05 1.60181334416E-05 1.62764784171E-05 1.65389899473E-05 1.68057352266E-05 1.70767825326E-05 1.73522012442E-05 1.76320618588E-05 1.79164360107E-05 1.82053964893E-05 1.84990172577E-05 1.87973734719E-05 1.91005414994E-05 1.94085989394E-05 1.97216246422E-05 2.00396987297E-05 2.03629026158E-05 2.06913190268E-05 2.10250320234E-05 2.13641270214E-05 2.17086908140E-05 2.20588115941E-05 2.24145789762E-05 2.27760840201E-05 2.31434192539E-05 2.35166786974E-05 2.38959578865E-05 2.42813538976E-05 2.46729653722E-05 2.50708925425E-05 2.54752372565E-05 2.58861030046E-05 2.63035949457E-05 2.67278199345E-05 2.71588865482E-05 2.75969051149E-05 2.80419877414E-05 2.84942483420E-05 2.89538026678E-05 2.94207683360E-05 2.98952648603E-05 3.03774136811E-05 3.08673381968E-05 3.13651637954E-05 3.18710178865E-05 3.23850299336E-05 3.29073314877E-05 3.34380562207E-05 3.39773399593E-05 3.45253207202E-05 3.50821387454E-05 3.56479365373E-05 3.62228588962E-05 3.68070529566E-05 3.74006682249E-05 3.80038566180E-05 3.86167725017E-05 3.92395727304E-05 3.98724166871E-05 4.05154663243E-05 4.11688862052E-05 4.18328435458E-05 4.25075082578E-05 4.31930529919E-05 4.38896531820E-05 4.45974870900E-05 4.53167358512E-05 4.60475835210E-05 4.67902171216E-05 4.75448266898E-05 4.83116053258E-05 4.90907492425E-05 4.98824578152E-05 5.06869336334E-05 5.15043825516E-05 5.23350137428E-05 5.31790397511E-05 5.40366765469E-05 5.49081435812E-05 5.57936638424E-05 5.66934639128E-05 5.76077740266E-05 5.85368281289E-05 5.94808639353E-05 6.04401229926E-05 6.14148507406E-05 6.24052965747E-05 6.34117139097E-05 6.44343602446E-05 6.54734972281E-05 6.65293907256E-05 6.76023108870E-05 6.86925322160E-05 6.98003336397E-05 7.09259985804E-05 7.20698150274E-05 7.32320756109E-05 7.44130776766E-05 7.56131233618E-05 7.68325196721E-05 7.80715785603E-05 7.93306170057E-05 8.06099570950E-05 8.19099261048E-05 8.32308565849E-05 8.45730864432E-05 8.59369590320E-05 8.73228232357E-05 8.87310335596E-05 9.01619502206E-05 9.16159392390E-05 9.30933725320E-05 9.45946280084E-05 9.61200896652E-05 9.76701476855E-05 9.92451985380E-05 1.00845645078E-04 1.02471896651E-04 1.04124369196E-04 1.05803485351E-04 1.07509674564E-04 1.09243373198E-04 1.11005024646E-04 1.12795079443E-04 1.14613995380E-04 1.16462237620E-04 1.18340278819E-04 1.20248599246E-04 1.22187686903E-04 1.24158037653E-04 1.26160155343E-04 1.28194551934E-04 1.30261747632E-04 1.32362271020E-04 1.34496659191E-04 1.36665457889E-04 1.38869221643E-04 1.41108513911E-04 1.43383907226E-04 1.45695983334E-04 1.48045333352E-04 1.50432557910E-04 1.52858267310E-04 1.55323081678E-04 1.57827631123E-04 1.60372555898E-04 1.62958506559E-04 1.65586144139E-04 1.68256140306E-04 1.70969177542E-04 1.73725949312E-04 1.76527160242E-04 1.79373526300E-04 1.82265774973E-04 1.85204645459E-04 1.88190888848E-04 1.91225268319E-04 1.94308559328E-04 1.97441549812E-04 2.00625040384E-04 2.03859844537E-04 2.07146788854E-04 2.10486713215E-04 2.13880471010E-04 2.17328929360E-04 2.20832969331E-04 2.24393486164E-04 2.28011389498E-04 2.31687603601E-04 2.35423067609E-04 2.39218735759E-04 2.43075577635E-04 2.46994578412E-04 2.50976739105E-04 2.55023076828E-04 2.59134625045E-04 2.63312433837E-04 2.67557570168E-04 2.71871118153E-04 2.76254179333E-04 2.80707872959E-04 2.85233336267E-04 2.89831724776E-04 2.94504212572E-04 2.99251992612E-04 3.04076277021E-04 3.08978297403E-04 3.13959305150E-04 3.19020571760E-04 3.24163389158E-04 3.29389070023E-04 3.34698948123E-04 3.40094378645E-04 3.45576738547E-04 3.51147426898E-04 3.56807865238E-04 3.62559497931E-04 3.68403792536E-04 3.74342240172E-04 3.80376355902E-04 3.86507679105E-04 3.92737773876E-04 3.99068229411E-04 4.05500660415E-04 4.12036707505E-04 4.18678037626E-04 4.25426344471E-04 4.32283348906E-04 4.39250799405E-04 4.46330472492E-04 4.53524173187E-04 4.60833735458E-04 4.68261022689E-04 4.75807928142E-04 4.83476375437E-04 4.91268319036E-04 4.99185744733E-04 5.07230670156E-04 5.15405145267E-04 5.23711252887E-04 5.32151109211E-04 5.40726864343E-04 5.49440702835E-04 5.58294844234E-04 5.67291543642E-04 5.76433092275E-04 5.85721818045E-04 5.95160086138E-04 6.04750299608E-04 6.14494899979E-04 6.24396367857E-04 6.34457223546E-04 6.44680027686E-04 6.55067381885E-04 6.65621929375E-04 6.76346355671E-04 6.87243389239E-04 6.98315802180E-04 7.09566410921E-04 7.20998076917E-04 7.32613707362E-04 7.44416255919E-04 7.56408723451E-04 7.68594158768E-04 7.80975659389E-04 7.93556372310E-04 8.06339494786E-04 8.19328275128E-04 8.32526013505E-04 8.45936062770E-04 8.59561829285E-04 8.73406773770E-04 8.87474412159E-04 9.01768316472E-04 9.16292115698E-04 9.31049496695E-04 9.46044205099E-04 9.61280046252E-04 9.76760886141E-04 9.92490652352E-04 1.00847333504E-03 1.02471298791E-03 1.04121372923E-03 1.05797974281E-03 1.07501527907E-03 1.09232465608E-03 1.10991226060E-03 1.12778254915E-03 1.14594004916E-03 1.16438936002E-03 1.18313515423E-03 1.20218217855E-03 1.22153525516E-03 1.24119928283E-03 1.26117923811E-03 1.28148017657E-03 1.30210723403E-03 1.32306562779E-03 1.34436065791E-03 1.36599770850E-03 1.38798224905E-03 1.41031983572E-03 1.43301611273E-03 1.45607681368E-03 1.47950776299E-03 1.50331487728E-03 1.52750416680E-03 1.55208173691E-03 1.57705378950E-03 1.60242662455E-03 1.62820664159E-03 1.65440034129E-03 1.68101432698E-03 1.70805530624E-03 1.73553009257E-03 1.76344560691E-03 1.79180887942E-03 1.82062705106E-03 1.84990737536E-03 1.87965722009E-03 1.90988406910E-03 1.94059552400E-03 1.97179930605E-03 2.00350325794E-03 2.03571534568E-03 2.06844366045E-03 2.10169642054E-03 2.13548197329E-03 2.16980879705E-03 2.20468550316E-03 2.24012083800E-03 2.27612368502E-03 2.31270306682E-03 2.34986814731E-03 2.38762823377E-03 2.42599277907E-03 2.46497138387E-03 2.50457379884E-03 2.54480992691E-03 2.58568982559E-03 2.62722370929E-03 2.66942195164E-03 2.71229508794E-03 2.75585381752E-03 2.80010900626E-03 2.84507168901E-03 2.89075307217E-03 2.93716453621E-03 2.98431763827E-03 3.03222411481E-03 3.08089588422E-03 3.13034504957E-03 3.18058390129E-03 3.23162491998E-03 3.28348077920E-03 3.33616434830E-03 3.38968869529E-03 3.44406708981E-03 3.49931300599E-03 3.55544012552E-03 3.61246234065E-03 3.67039375725E-03 3.72924869792E-03 3.78904170513E-03 3.84978754441E-03 3.91150120758E-03 3.97419791599E-03 4.03789312384E-03 4.10260252154E-03 4.16834203903E-03 4.23512784929E-03 4.30297637173E-03 4.37190427574E-03 4.44192848423E-03 4.51306617719E-03 4.58533479537E-03 4.65875204390E-03 4.73333589605E-03 4.80910459695E-03 4.88607666739E-03 4.96427090770E-03 5.04370640157E-03 5.12440252002E-03 5.20637892535E-03 5.28965557516E-03 5.37425272636E-03 5.46019093931E-03 5.54749108195E-03 5.63617433392E-03 5.72626219087E-03 5.81777646862E-03 5.91073930755E-03 6.00517317686E-03 6.10110087903E-03 6.19854555418E-03 6.29753068458E-03 6.39808009912E-03 6.50021797787E-03 6.60396885666E-03 6.70935763169E-03 6.81640956421E-03 6.92515028519E-03 7.03560580008E-03 7.14780249355E-03 7.26176713432E-03 7.37752687998E-03 7.49510928187E-03 7.61454228998E-03 7.73585425792E-03 7.85907394784E-03 7.98423053544E-03 8.11135361502E-03 8.24047320453E-03 8.37161975062E-03 8.50482413377E-03 8.64011767343E-03 8.77753213313E-03 8.91709972569E-03 9.05885311838E-03 9.20282543815E-03 9.34905027682E-03 9.49756169633E-03 9.64839423398E-03 9.80158290768E-03 9.95716322121E-03 1.01151711695E-02 1.02756432437E-02 1.04386164369E-02 1.06041282488E-02 1.07722166914E-02 1.09429202941E-02 1.11162781087E-02 1.12923297149E-02 1.14711152256E-02 1.16526752914E-02 1.18370511066E-02 1.20242844134E-02 1.22144175079E-02 1.24074932442E-02 1.26035550400E-02 1.28026468813E-02 1.30048133273E-02 1.32100995149E-02 1.34185511641E-02 1.36302145819E-02 1.38451366675E-02 1.40633649164E-02 1.42849474247E-02 1.45099328941E-02 1.47383706353E-02 1.49703105724E-02 1.52058032469E-02 1.54448998217E-02 1.56876520843E-02 1.59341124508E-02 1.61843339692E-02 1.64383703224E-02 1.66962758315E-02 1.69581054588E-02 1.72239148100E-02 1.74937601371E-02 1.77676983407E-02 1.80457869715E-02 1.83280842327E-02 1.86146489814E-02 1.89055407295E-02 1.92008196451E-02 1.95005465533E-02 1.98047829360E-02 2.01135909326E-02 2.04270333396E-02 2.07451736095E-02 2.10680758506E-02 2.13958048251E-02 2.17284259475E-02 2.20660052821E-02 2.24086095410E-02 2.27563060804E-02 2.31091628972E-02 2.34672486250E-02 2.38306325294E-02 2.41993845027E-02 2.45735750587E-02 2.49532753253E-02 2.53385570388E-02 2.57294925354E-02 2.61261547432E-02 2.65286171732E-02 2.69369539097E-02 2.73512395996E-02 2.77715494413E-02 2.81979591725E-02 2.86305450574E-02 2.90693838726E-02 2.95145528928E-02 2.99661298744E-02 3.04241930395E-02 3.08888210577E-02 3.13600930274E-02 3.18380884560E-02 3.23228872385E-02 3.28145696358E-02 3.33132162503E-02 3.38189080021E-02 3.43317261020E-02 3.48517520245E-02 3.53790674789E-02 3.59137543783E-02 3.64558948084E-02 3.70055709934E-02 3.75628652610E-02 3.81278600058E-02 3.87006376501E-02 3.92812806041E-02 3.98698712231E-02 4.04664917636E-02 4.10712243366E-02 4.16841508599E-02 4.23053530072E-02 4.29349121557E-02 4.35729093311E-02 4.42194251501E-02 4.48745397614E-02 4.55383327827E-02 4.62108832366E-02 4.68922694832E-02 4.75825691494E-02 4.82818590568E-02 4.89902151453E-02 4.97077123946E-02 5.04344247423E-02 5.11704249992E-02 5.19157847605E-02 5.26705743149E-02 5.34348625491E-02 5.42087168498E-02 5.49922030014E-02 5.57853850802E-02 5.65883253450E-02 5.74010841234E-02 5.82237196948E-02 5.90562881684E-02 5.98988433577E-02 6.07514366506E-02 6.16141168748E-02 6.24869301593E-02 6.33699197904E-02 6.42631260641E-02 6.51665861329E-02 6.60803338481E-02 6.70043995969E-02 6.79388101349E-02 6.88835884126E-02 6.98387533976E-02 7.08043198905E-02 7.17802983363E-02 7.27666946295E-02 7.37635099141E-02 7.47707403773E-02 7.57883770384E-02 7.68164055311E-02 7.78548058798E-02 7.89035522707E-02 7.99626128162E-02 8.10319493135E-02 8.21115169973E-02 8.32012642856E-02 8.43011325205E-02 8.54110557018E-02 8.65309602152E-02 8.76607645534E-02 8.88003790321E-02 8.99497054995E-02 9.11086370388E-02 9.22770576666E-02 9.34548420232E-02 9.46418550589E-02 9.58379517132E-02 9.70429765892E-02 9.82567636221E-02 9.94791357426E-02 1.00709904535E-01 1.01948869891E-01 1.03195819657E-01 1.04450529281E-01 1.05712761448E-01 1.06982265723E-01 1.08258778177E-01 1.09542021023E-01 1.10831702238E-01 1.12127515192E-01 1.13429138269E-01 1.14736234490E-01 1.16048451135E-01 1.17365419366E-01 1.18686753846E-01 1.20012052365E-01 1.21340895469E-01 1.22672846081E-01 1.24007449145E-01 1.25344231252E-01 1.26682700294E-01 1.28022345106E-01 1.29362635130E-01 1.30703020077E-01 1.32042929609E-01 1.33381773026E-01 1.34718938965E-01 1.36053795120E-01 1.37385687972E-01 1.38713942536E-01 1.40037862134E-01 1.41356728176E-01 1.42669799977E-01 1.43976314591E-01 1.45275486669E-01 1.46566508350E-01 1.47848549181E-01 1.49120756070E-01 1.50382253268E-01 1.51632142394E-01 1.52869502498E-01 1.54093390165E-01 1.55302839660E-01 1.56496863122E-01 1.57674450810E-01 1.58834571395E-01 1.59976172312E-01 1.61098180163E-01 1.62199501185E-01 1.63279021780E-01 1.64335609107E-01 1.65368111747E-01 1.66375360437E-01 1.67356168875E-01 1.68309334608E-01 1.69233639994E-01 1.70127853251E-01 1.70990729584E-01 1.71821012408E-01 1.72617434657E-01 1.73378720182E-01 1.74103585247E-01 1.74790740127E-01 1.75438890794E-01 1.76046740709E-01 1.76612992722E-01 1.77136351059E-01 1.77615523436E-01 1.78049223253E-01 1.78436171916E-01 1.78775101252E-01 1.79064756029E-01 1.79303896589E-01 1.79491301575E-01 1.79625770769E-01 1.79706128021E-01 1.79731224281E-01 1.79699940724E-01 1.79611191965E-01 1.79463929355E-01 1.79257144369E-01 1.78989872056E-01 1.78661194562E-01 1.78270244721E-01 1.77816209689E-01 1.77298334624E-01 1.76715926407E-01 1.76068357379E-01 1.75355069093E-01 1.74575576069E-01 1.73729469532E-01 1.72816421124E-01 1.71836186571E-01 1.70788609303E-01 1.69673623982E-01 1.68491259951E-01 1.67241644566E-01 1.65925006399E-01 1.64541678294E-01 1.63092100244E-01 1.61576822085E-01 1.59996505968E-01 1.58351928602E-01 1.56643983230E-01 1.54873681327E-01 1.53042153990E-01 1.51150653001E-01 1.49200551535E-01 1.47193344494E-01 1.45130648444E-01 1.43014201125E-01 1.40845860530E-01 1.38627603514E-01 1.36361523925E-01 1.34049830236E-01 1.31694842663E-01 1.29298989750E-01 1.26864804419E-01 1.24394919465E-01 1.21892062491E-01 1.19359050286E-01 1.16798782636E-01 1.14214235573E-01 1.11608454074E-01 1.08984544207E-01 1.06345664751E-01 1.03695018306E-01 1.01035841905E-01 9.83713971712E-02 9.57049600425E-02 9.30398101082E-02 9.03792195939E-02 8.77264420492E-02 8.50847007890E-02 8.24571771471E-02 7.98469986086E-02 7.72572268883E-02 7.46908460305E-02 7.21507506104E-02 6.96397341195E-02 6.71604776236E-02 6.47155387864E-02 6.23073413517E-02 5.99381651852E-02 5.76101369736E-02 5.53252216844E-02 5.30852148892E-02 5.08917360529E-02 4.87462228903E-02 4.66499268924E-02 4.46039101176E-02 4.26090433438E-02 4.06660056684E-02 3.87752856422E-02 3.69371840103E-02 3.51518181299E-02 3.34191281229E-02 3.17388848110E-02 3.01106994684E-02 2.85340354164E-02 2.70082214665E-02 2.55324672063E-02 2.41058801022E-02 2.27274843798E-02 2.13962416176E-02 2.01110729759E-02 1.88708829563E-02 1.76745845685E-02 1.65211257560E-02 1.54095169086E-02 1.43388592657E-02 1.33083739861E-02 1.23174316377E-02 1.13655818275E-02 1.04525826712E-02 9.57842976706E-03 8.74338431617E-03 7.94799999698E-03 7.19314817747E-03 6.48004101715E-03 5.81025198428E-03 5.18517971429E-03 4.60424603748E-03 4.06629112859E-03 3.57008947670E-03 3.11435072683E-03 2.69772062715E-03 2.31878209823E-03 1.97605644296E-03 1.66800471790E-03 1.39302928944E-03 1.14947560008E-03 9.35634173432E-04 7.49742888308E-04 5.89989555556E-04 4.54514833668E-04 3.41415522012E-04 2.48748273287E-04 1.74533769507E-04 1.16761408549E-04 7.33945509095E-05 4.23763789284E-05 2.16364231213E-05 9.09781261118E-06 2.68530871998E-06 3.34182677591E-07 3.03827622908E-17 -3.50321976773E-18 1.26796260810E-17 1.27028865442E-17 -1.07321279993E-17 -2.54390991240E-17 1.57412006439E-18 -2.33846506077E-18 -1.25147545066E-17 1.01741139155E-17 1.01574936577E-17 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1 3 1 i j (l(j)) 0.00000000000E+00 Q_int 1.52927741601E-09 1.56642384972E-09 1.60447257392E-09 1.64344550519E-09 1.68336509247E-09 1.72425432998E-09 1.76613677044E-09 1.80903653868E-09 1.85297834551E-09 1.89798750195E-09 1.94408993382E-09 1.99131219666E-09 2.03968149105E-09 2.08922567825E-09 2.13997329626E-09 2.19195357626E-09 2.24519645942E-09 2.29973261421E-09 2.35559345399E-09 2.41281115515E-09 2.47141867561E-09 2.53144977385E-09 2.59293902830E-09 2.65592185730E-09 2.72043453948E-09 2.78651423465E-09 2.85419900520E-09 2.92352783807E-09 2.99454066714E-09 3.06727839626E-09 3.14178292282E-09 3.21809716186E-09 3.29626507081E-09 3.37633167480E-09 3.45834309256E-09 3.54234656305E-09 3.62839047259E-09 3.71652438282E-09 3.80679905914E-09 3.89926650003E-09 3.99397996698E-09 4.09099401514E-09 4.19036452476E-09 4.29214873340E-09 4.39640526883E-09 4.50319418288E-09 4.61257698594E-09 4.72461668248E-09 4.83937780724E-09 4.95692646249E-09 5.07733035602E-09 5.20065884021E-09 5.32698295191E-09 5.45637545340E-09 5.58891087427E-09 5.72466555435E-09 5.86371768769E-09 6.00614736756E-09 6.15203663264E-09 6.30146951420E-09 6.45453208454E-09 6.61131250656E-09 6.77190108450E-09 6.93639031600E-09 7.10487494534E-09 7.27745201801E-09 7.45422093659E-09 7.63528351803E-09 7.82074405227E-09 8.01070936227E-09 8.20528886561E-09 8.40459463742E-09 8.60874147499E-09 8.81784696383E-09 9.03203154544E-09 9.25141858664E-09 9.47613445062E-09 9.70630856972E-09 9.94207351998E-09 1.01835650975E-08 1.04309223965E-08 1.06842878898E-08 1.09438075103E-08 1.12096307356E-08 1.14819106737E-08 1.17608041513E-08 1.20464718041E-08 1.23390781695E-08 1.26387917808E-08 1.29457852649E-08 1.32602354414E-08 1.35823234244E-08 1.39122347269E-08 1.42501593676E-08 1.45962919802E-08 1.49508319258E-08 1.53139834073E-08 1.56859555873E-08 1.60669627084E-08 1.64572242167E-08 1.68569648879E-08 1.72664149571E-08 1.76858102511E-08 1.81153923243E-08 1.85554085978E-08 1.90061125019E-08 1.94677636218E-08 1.99406278476E-08 2.04249775268E-08 2.09210916215E-08 2.14292558690E-08 2.19497629460E-08 2.24829126378E-08 2.30290120102E-08 2.35883755867E-08 2.41613255295E-08 2.47481918250E-08 2.53493124740E-08 2.59650336858E-08 2.65957100782E-08 2.72417048812E-08 2.79033901464E-08 2.85811469610E-08 2.92753656674E-08 2.99864460879E-08 3.07147977549E-08 3.14608401466E-08 3.22250029285E-08 3.30077262012E-08 3.38094607532E-08 3.46306683206E-08 3.54718218533E-08 3.63334057869E-08 3.72159163216E-08 3.81198617081E-08 3.90457625400E-08 3.99941520539E-08 4.09655764357E-08 4.19605951356E-08 4.29797811901E-08 4.40237215517E-08 4.50930174268E-08 4.61882846219E-08 4.73101538984E-08 4.84592713350E-08 4.96362987001E-08 5.08419138330E-08 5.20768110333E-08 5.33417014613E-08 5.46373135470E-08 5.59643934097E-08 5.73237052869E-08 5.87160319750E-08 6.01421752793E-08 6.16029564757E-08 6.30992167833E-08 6.46318178490E-08 6.62016422429E-08 6.78095939667E-08 6.94565989738E-08 7.11436057023E-08 7.28715856210E-08 7.46415337882E-08 7.64544694247E-08 7.83114365003E-08 8.02135043346E-08 8.21617682124E-08 8.41573500139E-08 8.62013988608E-08 8.82950917770E-08 9.04396343665E-08 9.26362615067E-08 9.48862380595E-08 9.71908595986E-08 9.95514531557E-08 1.01969377983E-07 1.04446026338E-07 1.06982824280E-07 1.09581232496E-07 1.12242747137E-07 1.14968900680E-07 1.17761262812E-07 1.20621441329E-07 1.23551083066E-07 1.26551874840E-07 1.29625544422E-07 1.32773861532E-07 1.35998638858E-07 1.39301733094E-07 1.42685046015E-07 1.46150525564E-07 1.49700166978E-07 1.53336013933E-07 1.57060159722E-07 1.60874748455E-07 1.64781976296E-07 1.68784092726E-07 1.72883401834E-07 1.77082263644E-07 1.81383095475E-07 1.85788373325E-07 1.90300633302E-07 1.94922473078E-07 1.99656553384E-07 2.04505599541E-07 2.09472403025E-07 2.14559823076E-07 2.19770788338E-07 2.25108298546E-07 2.30575426251E-07 2.36175318583E-07 2.41911199064E-07 2.47786369460E-07 2.53804211682E-07 2.59968189726E-07 2.66281851665E-07 2.72748831692E-07 2.79372852208E-07 2.86157725959E-07 2.93107358232E-07 3.00225749095E-07 3.07516995701E-07 3.14985294638E-07 3.22634944347E-07 3.30470347585E-07 3.38496013963E-07 3.46716562531E-07 3.55136724435E-07 3.63761345639E-07 3.72595389704E-07 3.81643940642E-07 3.90912205838E-07 4.00405519043E-07 4.10129343435E-07 4.20089274759E-07 4.30291044543E-07 4.40740523390E-07 4.51443724348E-07 4.62406806367E-07 4.73636077832E-07 4.85138000192E-07 4.96919191668E-07 5.08986431052E-07 5.21346661603E-07 5.34006995031E-07 5.46974715583E-07 5.60257284226E-07 5.73862342926E-07 5.87797719042E-07 6.02071429812E-07 6.16691686964E-07 6.31666901421E-07 6.47005688134E-07 6.62716871026E-07 6.78809488056E-07 6.95292796403E-07 7.12176277782E-07 7.29469643883E-07 7.47182841943E-07 7.65326060454E-07 7.83909735009E-07 8.02944554286E-07 8.22441466180E-07 8.42411684086E-07 8.62866693325E-07 8.83818257737E-07 9.05278426420E-07 9.27259540647E-07 9.49774240936E-07 9.72835474303E-07 9.96456501678E-07 1.02065090551E-06 1.04543259756E-06 1.07081582687E-06 1.09681518790E-06 1.12344562896E-06 1.15072246070E-06 1.17866136494E-06 1.20727840363E-06 1.23659002803E-06 1.26661308819E-06 1.29736484255E-06 1.32886296784E-06 1.36112556922E-06 1.39417119062E-06 1.42801882538E-06 1.46268792711E-06 1.49819842084E-06 1.53457071439E-06 1.57182571011E-06 1.60998481678E-06 1.64906996190E-06 1.68910360423E-06 1.73010874661E-06 1.77210894917E-06 1.81512834275E-06 1.85919164274E-06 1.90432416319E-06 1.95055183131E-06 1.99790120224E-06 2.04639947430E-06 2.09607450449E-06 2.14695482441E-06 2.19906965656E-06 2.25244893109E-06 2.30712330281E-06 2.36312416877E-06 2.42048368615E-06 2.47923479066E-06 2.53941121530E-06 2.60104750964E-06 2.66417905955E-06 2.72884210738E-06 2.79507377263E-06 2.86291207314E-06 2.93239594680E-06 3.00356527371E-06 3.07646089895E-06 3.15112465585E-06 3.22759938988E-06 3.30592898300E-06 3.38615837873E-06 3.46833360773E-06 3.55250181401E-06 3.63871128181E-06 3.72701146308E-06 3.81745300562E-06 3.91008778193E-06 4.00496891874E-06 4.10215082721E-06 4.20168923392E-06 4.30364121252E-06 4.40806521624E-06 4.51502111107E-06 4.62457020985E-06 4.73677530706E-06 4.85170071451E-06 4.96941229789E-06 5.08997751417E-06 5.21346544990E-06 5.33994686041E-06 5.46949421002E-06 5.60218171306E-06 5.73808537607E-06 5.87728304085E-06 6.01985442857E-06 6.16588118503E-06 6.31544692686E-06 6.46863728890E-06 6.62553997275E-06 6.78624479634E-06 6.95084374488E-06 7.11943102279E-06 7.29210310710E-06 7.46895880195E-06 7.65009929446E-06 7.83562821196E-06 8.02565168048E-06 8.22027838475E-06 8.41961962955E-06 8.62378940252E-06 8.83290443853E-06 9.04708428549E-06 9.26645137179E-06 9.49113107530E-06 9.72125179402E-06 9.95694501844E-06 1.01983454056E-05 1.04455908547E-05 1.06988225850E-05 1.09581852150E-05 1.12238268441E-05 1.14958991351E-05 1.17745574005E-05 1.20599606885E-05 1.23522718734E-05 1.26516577463E-05 1.29582891086E-05 1.32723408684E-05 1.35939921379E-05 1.39234263338E-05 1.42608312803E-05 1.46063993139E-05 1.49603273913E-05 1.53228171989E-05 1.56940752662E-05 1.60743130809E-05 1.64637472067E-05 1.68625994045E-05 1.72710967557E-05 1.76894717892E-05 1.81179626104E-05 1.85568130343E-05 1.90062727207E-05 1.94665973133E-05 1.99380485818E-05 2.04208945670E-05 2.09154097301E-05 2.14218751043E-05 2.19405784513E-05 2.24718144201E-05 2.30158847108E-05 2.35730982409E-05 2.41437713166E-05 2.47282278074E-05 2.53267993249E-05 2.59398254059E-05 2.65676536996E-05 2.72106401592E-05 2.78691492379E-05 2.85435540894E-05 2.92342367729E-05 2.99415884634E-05 3.06660096661E-05 3.14079104360E-05 3.21677106031E-05 3.29458400019E-05 3.37427387066E-05 3.45588572718E-05 3.53946569786E-05 3.62506100862E-05 3.71272000895E-05 3.80249219824E-05 3.89442825272E-05 3.98858005300E-05 4.08500071227E-05 4.18374460510E-05 4.28486739694E-05 4.38842607424E-05 4.49447897526E-05 4.60308582165E-05 4.71430775064E-05 4.82820734804E-05 4.94484868190E-05 5.06429733704E-05 5.18662045023E-05 5.31188674629E-05 5.44016657489E-05 5.57153194820E-05 5.70605657948E-05 5.84381592235E-05 5.98488721112E-05 6.12934950190E-05 6.27728371464E-05 6.42877267617E-05 6.58390116411E-05 6.74275595177E-05 6.90542585413E-05 7.07200177468E-05 7.24257675341E-05 7.41724601582E-05 7.59610702298E-05 7.77925952271E-05 7.96680560191E-05 8.15884973990E-05 8.35549886313E-05 8.55686240087E-05 8.76305234222E-05 8.97418329436E-05 9.19037254196E-05 9.41174010800E-05 9.63840881578E-05 9.87050435231E-05 1.01081553331E-04 1.03514933681E-04 1.06006531295E-04 1.08557724206E-04 1.11169922458E-04 1.13844568833E-04 1.16583139578E-04 1.19387145158E-04 1.22258131019E-04 1.25197678372E-04 1.28207404988E-04 1.31288966011E-04 1.34444054792E-04 1.37674403734E-04 1.40981785157E-04 1.44368012184E-04 1.47834939636E-04 1.51384464957E-04 1.55018529148E-04 1.58739117726E-04 1.62548261697E-04 1.66448038552E-04 1.70440573284E-04 1.74528039421E-04 1.78712660082E-04 1.82996709056E-04 1.87382511892E-04 1.91872447029E-04 1.96468946924E-04 2.01174499226E-04 2.05991647950E-04 2.10922994694E-04 2.15971199862E-04 2.21138983921E-04 2.26429128677E-04 2.31844478576E-04 2.37387942028E-04 2.43062492758E-04 2.48871171179E-04 2.54817085791E-04 2.60903414605E-04 2.67133406593E-04 2.73510383166E-04 2.80037739671E-04 2.86718946924E-04 2.93557552762E-04 3.00557183624E-04 3.07721546163E-04 3.15054428878E-04 3.22559703779E-04 3.30241328078E-04 3.38103345910E-04 3.46149890076E-04 3.54385183821E-04 3.62813542635E-04 3.71439376091E-04 3.80267189696E-04 3.89301586789E-04 3.98547270455E-04 4.08009045470E-04 4.17691820280E-04 4.27600609005E-04 4.37740533468E-04 4.48116825261E-04 4.58734827832E-04 4.69599998608E-04 4.80717911136E-04 4.92094257265E-04 5.03734849344E-04 5.15645622455E-04 5.27832636669E-04 5.40302079337E-04 5.53060267395E-04 5.66113649707E-04 5.79468809424E-04 5.93132466381E-04 6.07111479501E-04 6.21412849242E-04 6.36043720052E-04 6.51011382853E-04 6.66323277549E-04 6.81986995552E-04 6.98010282324E-04 7.14401039947E-04 7.31167329701E-04 7.48317374666E-04 7.65859562335E-04 7.83802447241E-04 8.02154753601E-04 8.20925377962E-04 8.40123391865E-04 8.59758044512E-04 8.79838765437E-04 9.00375167187E-04 9.21377047996E-04 9.42854394464E-04 9.64817384231E-04 9.87276388646E-04 1.01024197542E-03 1.03372491130E-03 1.05773616466E-03 1.08228690815E-03 1.10738852130E-03 1.13305259307E-03 1.15929092441E-03 1.18611553075E-03 1.21353864453E-03 1.24157271761E-03 1.27023042362E-03 1.29952466042E-03 1.32946855228E-03 1.36007545220E-03 1.39135894401E-03 1.42333284456E-03 1.45601120568E-03 1.48940831615E-03 1.52353870357E-03 1.55841713614E-03 1.59405862430E-03 1.63047842230E-03 1.66769202966E-03 1.70571519248E-03 1.74456390466E-03 1.78425440889E-03 1.82480319763E-03 1.86622701383E-03 1.90854285148E-03 1.95176795609E-03 1.99591982482E-03 2.04101620660E-03 2.08707510186E-03 2.13411476218E-03 2.18215368963E-03 2.23121063591E-03 2.28130460119E-03 2.33245483272E-03 2.38468082316E-03 2.43800230854E-03 2.49243926605E-03 2.54801191131E-03 2.60474069551E-03 2.66264630200E-03 2.72174964264E-03 2.78207185367E-03 2.84363429126E-03 2.90645852650E-03 2.97056634010E-03 3.03597971648E-03 3.10272083746E-03 3.17081207544E-03 3.24027598596E-03 3.31113529985E-03 3.38341291471E-03 3.45713188577E-03 3.53231541624E-03 3.60898684694E-03 3.68716964521E-03 3.76688739328E-03 3.84816377575E-03 3.93102256643E-03 4.01548761438E-03 4.10158282911E-03 4.18933216498E-03 4.27875960477E-03 4.36988914227E-03 4.46274476406E-03 4.55735043021E-03 4.65373005412E-03 4.75190748128E-03 4.85190646697E-03 4.95375065291E-03 5.05746354278E-03 5.16306847662E-03 5.27058860398E-03 5.38004685595E-03 5.49146591583E-03 5.60486818860E-03 5.72027576902E-03 5.83771040842E-03 5.95719347999E-03 6.07874594282E-03 6.20238830426E-03 6.32814058099E-03 6.45602225838E-03 6.58605224842E-03 6.71824884594E-03 6.85262968326E-03 6.98921168313E-03 7.12801101000E-03 7.26904301953E-03 7.41232220634E-03 7.55786214997E-03 7.70567545899E-03 7.85577371331E-03 8.00816740456E-03 8.16286587461E-03 8.31987725213E-03 8.47920838724E-03 8.64086478418E-03 8.80485053200E-03 8.97116823332E-03 9.13981893099E-03 9.31080203285E-03 9.48411523441E-03 9.65975443959E-03 9.83771367941E-03 1.00179850287E-02 1.02005585210E-02 1.03854220609E-02 1.05725613356E-02 1.07619597232E-02 1.09535982004E-02 1.11474552471E-02 1.13435067507E-02 1.15417259071E-02 1.17420831214E-02 1.19445459063E-02 1.21490787792E-02 1.23556431577E-02 1.25641972539E-02 1.27746959681E-02 1.29870907802E-02 1.32013296410E-02 1.34173568628E-02 1.36351130087E-02 1.38545347820E-02 1.40755549147E-02 1.42981020566E-02 1.45221006638E-02 1.47474708882E-02 1.49741284666E-02 1.52019846114E-02 1.54309459022E-02 1.56609141784E-02 1.58917864340E-02 1.61234547135E-02 1.63558060110E-02 1.65887221714E-02 1.68220797950E-02 1.70557501448E-02 1.72895990587E-02 1.75234868650E-02 1.77572683032E-02 1.79907924495E-02 1.82239026487E-02 1.84564364514E-02 1.86882255586E-02 1.89190957737E-02 1.91488669615E-02 1.93773530165E-02 1.96043618403E-02 1.98296953282E-02 2.00531493666E-02 2.02745138415E-02 2.04935726584E-02 2.07101037756E-02 2.09238792496E-02 2.11346652953E-02 2.13422223610E-02 2.15463052185E-02 2.17466630699E-02 2.19430396717E-02 2.21351734763E-02 2.23227977933E-02 2.25056409697E-02 2.26834265905E-02 2.28558737014E-02 2.30226970530E-02 2.31836073681E-02 2.33383116330E-02 2.34865134132E-02 2.36279131945E-02 2.37622087506E-02 2.38890955365E-02 2.40082671110E-02 2.41194155862E-02 2.42222321061E-02 2.43164073553E-02 2.44016320965E-02 2.44775977394E-02 2.45439969400E-02 2.46005242306E-02 2.46468766815E-02 2.46827545946E-02 2.47078622273E-02 2.47219085488E-02 2.47246080276E-02 2.47156814491E-02 2.46948567649E-02 2.46618699707E-02 2.46164660145E-02 2.45583997327E-02 2.44874368130E-02 2.44033547837E-02 2.43059440276E-02 2.41950088188E-02 2.40703683802E-02 2.39318579604E-02 2.37793299273E-02 2.36126548758E-02 2.34317227472E-02 2.32364439569E-02 2.30267505274E-02 2.28025972229E-02 2.25639626824E-02 2.23108505457E-02 2.20432905699E-02 2.17613397303E-02 2.14650833018E-02 2.11546359149E-02 2.08301425813E-02 2.04917796839E-02 2.01397559237E-02 1.97743132194E-02 1.93957275516E-02 1.90043097463E-02 1.86004061893E-02 1.81843994658E-02 1.77567089175E-02 1.73177911095E-02 1.68681401995E-02 1.64082882026E-02 1.59388051420E-02 1.54602990807E-02 1.49734160241E-02 1.44788396862E-02 1.39772911141E-02 1.34695281595E-02 1.29563447942E-02 1.24385702589E-02 1.19170680418E-02 1.13927346785E-02 1.08664983686E-02 1.03393174028E-02 9.81217839748E-03 9.28609433018E-03 8.76210237478E-03 8.24126153280E-03 7.72465005930E-03 7.21336268275E-03 6.70850761905E-03 6.21120338124E-03 5.72257538723E-03 5.24375236964E-03 4.77586259260E-03 4.32002988225E-03 3.87736947869E-03 3.44898371896E-03 3.03595756199E-03 2.63935396800E-03 2.26020914678E-03 1.89952769046E-03 1.55827760844E-03 1.23738528363E-03 9.37730370882E-04 6.60140660137E-04 4.05386928386E-04 1.74177806267E-04 -3.28453135357E-05 -2.15113297343E-04 -3.72134190919E-04 -5.03498007959E-04 -6.08881354147E-04 -6.88051853268E-04 -7.40872341008E-04 -7.67304791355E-04 -7.67413939970E-04 -7.41370568570E-04 -6.89454414170E-04 -6.12056667144E-04 -5.09682022274E-04 -3.82950247510E-04 -2.32597235852E-04 -5.94755067353E-05 1.35445875502E-04 3.51081997089E-04 5.86233433571E-04 8.39588259350E-04 1.10972475342E-03 1.39511482441E-03 1.69412817573E-03 2.00503722867E-03 2.32602281898E-03 2.65518067917E-03 2.99052871598E-03 3.33001508938E-03 3.67152709630E-03 4.01290085916E-03 4.35193181612E-03 4.68638600695E-03 5.01401214523E-03 5.33255446460E-03 5.63976632413E-03 5.93342455473E-03 6.21134452627E-03 6.47139591206E-03 6.71151912556E-03 6.92974240126E-03 7.12419949011E-03 7.29314793732E-03 7.43498790869E-03 7.54828152960E-03 7.63177269861E-03 7.68440733584E-03 7.70535402414E-03 7.69402499834E-03 7.65009743581E-03 7.57353499803E-03 7.46460956988E-03 7.32392313899E-03 7.15242975308E-03 6.95145748763E-03 6.72273034991E-03 6.46839003784E-03 6.19101746360E-03 5.89365394178E-03 5.57982193041E-03 5.25354519968E-03 4.91936828815E-03 4.58237508871E-03 4.24743248525E-03 3.91669916853E-03 3.59162459912E-03 3.27366519100E-03 2.96427074979E-03 2.66486987871E-03 2.37685435863E-03 2.10156251428E-03 1.84026158563E-03 1.59412913058E-03 1.36423349264E-03 1.15151337579E-03 9.56756577220E-04 7.80577938289E-04 6.23396583816E-04 4.85412530722E-04 3.66582758263E-04 2.66596844288E-04 1.84852284777E-04 1.20429627710E-04 7.20675668059E-05 3.81381562452E-05 1.66223238625E-05 5.08587779901E-06 6.56220060846E-07 9.03492335066E-17 -1.54604924884E-17 -2.34885811668E-17 -1.50960323273E-17 -2.18804408072E-17 -7.51972734863E-17 -4.84045695704E-18 -1.15337853295E-18 -1.78266253786E-17 1.66145663477E-17 -2.26577357915E-17 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1 4 1 i j (l(j)) 0.00000000000E+00 Q_int 1.23028372500E-09 1.26016753886E-09 1.29077723316E-09 1.32213043949E-09 1.35424521770E-09 1.38714006632E-09 1.42083393317E-09 1.45534622634E-09 1.49069682531E-09 1.52690609246E-09 1.56399488472E-09 1.60198456565E-09 1.64089701772E-09 1.68075465493E-09 1.72158043566E-09 1.76339787600E-09 1.80623106319E-09 1.85010466954E-09 1.89504396667E-09 1.94107484001E-09 1.98822380373E-09 2.03651801602E-09 2.08598529475E-09 2.13665413343E-09 2.18855371769E-09 2.24171394205E-09 2.29616542715E-09 2.35193953740E-09 2.40906839901E-09 2.46758491854E-09 2.52752280179E-09 2.58891657330E-09 2.65180159614E-09 2.71621409236E-09 2.78219116379E-09 2.84977081345E-09 2.91899196743E-09 2.98989449729E-09 3.06251924304E-09 3.13690803667E-09 3.21310372623E-09 3.29115020050E-09 3.37109241429E-09 3.45297641434E-09 3.53684936579E-09 3.62275957939E-09 3.71075653933E-09 3.80089093169E-09 3.89321467368E-09 3.98778094355E-09 4.08464421114E-09 4.18386026936E-09 4.28548626624E-09 4.38958073787E-09 4.49620364213E-09 4.60541639319E-09 4.71728189693E-09 4.83186458709E-09 4.94923046247E-09 5.06944712487E-09 5.19258381808E-09 5.31871146769E-09 5.44790272202E-09 5.58023199390E-09 5.71577550354E-09 5.85461132244E-09 5.99681941834E-09 6.14248170128E-09 6.29168207078E-09 6.44450646414E-09 6.60104290596E-09 6.76138155879E-09 6.92561477510E-09 7.09383715046E-09 7.26614557799E-09 7.44263930418E-09 7.62341998606E-09 7.80859174971E-09 7.99826125025E-09 8.19253773326E-09 8.39153309769E-09 8.59536196030E-09 8.80414172166E-09 9.01799263378E-09 9.23703786933E-09 9.46140359261E-09 9.69121903218E-09 9.92661655527E-09 1.01677317440E-08 1.04147034736E-08 1.06676739922E-08 1.09267890026E-08 1.11921977467E-08 1.14640530910E-08 1.17425116148E-08 1.20277337001E-08 1.23198836246E-08 1.26191296554E-08 1.29256441467E-08 1.32396036386E-08 1.35611889589E-08 1.38905853273E-08 1.42279824619E-08 1.45735746883E-08 1.49275610521E-08 1.52901454329E-08 1.56615366618E-08 1.60419486421E-08 1.64316004718E-08 1.68307165704E-08 1.72395268076E-08 1.76582666359E-08 1.80871772264E-08 1.85265056070E-08 1.89765048054E-08 1.94374339944E-08 1.99095586410E-08 2.03931506595E-08 2.08884885682E-08 2.13958576492E-08 2.19155501133E-08 2.24478652678E-08 2.29931096890E-08 2.35515973988E-08 2.41236500452E-08 2.47095970878E-08 2.53097759874E-08 2.59245324003E-08 2.65542203770E-08 2.71992025666E-08 2.78598504252E-08 2.85365444297E-08 2.92296742971E-08 2.99396392089E-08 3.06668480404E-08 3.14117195968E-08 3.21746828537E-08 3.29561772045E-08 3.37566527130E-08 3.45765703728E-08 3.54164023724E-08 3.62766323673E-08 3.71577557582E-08 3.80602799762E-08 3.89847247750E-08 3.99316225301E-08 4.09015185453E-08 4.18949713661E-08 4.29125531022E-08 4.39548497557E-08 4.50224615592E-08 4.61160033211E-08 4.72361047791E-08 4.83834109633E-08 4.95585825670E-08 5.07622963273E-08 5.19952454140E-08 5.32581398296E-08 5.45517068170E-08 5.58766912783E-08 5.72338562039E-08 5.86239831112E-08 6.00478724946E-08 6.15063442861E-08 6.30002383270E-08 6.45304148519E-08 6.60977549828E-08 6.77031612369E-08 6.93475580456E-08 7.10318922868E-08 7.27571338293E-08 7.45242760914E-08 7.63343366123E-08 7.81883576375E-08 8.00874067188E-08 8.20325773284E-08 8.40249894883E-08 8.60657904142E-08 8.81561551763E-08 9.02972873749E-08 9.24904198330E-08 9.47368153056E-08 9.70377672063E-08 9.93946003514E-08 1.01808671722E-07 1.04281371245E-07 1.06814122591E-07 1.09408383997E-07 1.12065649101E-07 1.14787447804E-07 1.17575347150E-07 1.20430952225E-07 1.23355907083E-07 1.26351895691E-07 1.29420642895E-07 1.32563915416E-07 1.35783522864E-07 1.39081318780E-07 1.42459201700E-07 1.45919116248E-07 1.49463054254E-07 1.53093055903E-07 1.56811210900E-07 1.60619659681E-07 1.64520594638E-07 1.68516261382E-07 1.72608960031E-07 1.76801046539E-07 1.81094934044E-07 1.85493094259E-07 1.89998058892E-07 1.94612421102E-07 1.99338836989E-07 2.04180027121E-07 2.09138778101E-07 2.14217944164E-07 2.19420448820E-07 2.24749286536E-07 2.30207524454E-07 2.35798304157E-07 2.41524843471E-07 2.47390438320E-07 2.53398464613E-07 2.59552380190E-07 2.65855726807E-07 2.72312132170E-07 2.78925312022E-07 2.85699072274E-07 2.92637311199E-07 2.99744021664E-07 3.07023293427E-07 3.14479315489E-07 3.22116378496E-07 3.29938877209E-07 3.37951313022E-07 3.46158296555E-07 3.54564550294E-07 3.63174911312E-07 3.71994334041E-07 3.81027893117E-07 3.90280786300E-07 3.99758337453E-07 4.09465999600E-07 4.19409358060E-07 4.29594133651E-07 4.40026185974E-07 4.50711516781E-07 4.61656273415E-07 4.72866752341E-07 4.84349402763E-07 4.96110830319E-07 5.08157800880E-07 5.20497244427E-07 5.33136259029E-07 5.46082114918E-07 5.59342258659E-07 5.72924317422E-07 5.86836103360E-07 6.01085618089E-07 6.15681057276E-07 6.30630815346E-07 6.45943490290E-07 6.61627888601E-07 6.77693030321E-07 6.94148154216E-07 7.11002723072E-07 7.28266429121E-07 7.45949199597E-07 7.64061202429E-07 7.82612852066E-07 8.01614815451E-07 8.21078018129E-07 8.41013650514E-07 8.61433174297E-07 8.82348329016E-07 9.03771138780E-07 9.25713919159E-07 9.48189284241E-07 9.71210153852E-07 9.94789760959E-07 1.01894165925E-06 1.04367973088E-06 1.06901819446E-06 1.09497161315E-06 1.12155490301E-06 1.14878334155E-06 1.17667257649E-06 1.20523863465E-06 1.23449793121E-06 1.26446727901E-06 1.29516389825E-06 1.32660542629E-06 1.35880992776E-06 1.39179590487E-06 1.42558230802E-06 1.46018854662E-06 1.49563450018E-06 1.53194052967E-06 1.56912748920E-06 1.60721673787E-06 1.64623015204E-06 1.68619013778E-06 1.72711964369E-06 1.76904217404E-06 1.81198180211E-06 1.85596318403E-06 1.90101157280E-06 1.94715283272E-06 1.99441345417E-06 2.04282056868E-06 2.09240196448E-06 2.14318610230E-06 2.19520213164E-06 2.24847990735E-06 2.30305000673E-06 2.35894374687E-06 2.41619320258E-06 2.47483122465E-06 2.53489145855E-06 2.59640836360E-06 2.65941723266E-06 2.72395421214E-06 2.79005632267E-06 2.85776148012E-06 2.92710851720E-06 2.99813720558E-06 3.07088827850E-06 3.14540345396E-06 3.22172545842E-06 3.29989805113E-06 3.37996604902E-06 3.46197535213E-06 3.54597296972E-06 3.63200704700E-06 3.72012689245E-06 3.81038300585E-06 3.90282710693E-06 3.99751216475E-06 4.09449242775E-06 4.19382345455E-06 4.29556214544E-06 4.39976677467E-06 4.50649702350E-06 4.61581401398E-06 4.72778034366E-06 4.84246012099E-06 4.95991900168E-06 5.08022422584E-06 5.20344465605E-06 5.32965081636E-06 5.45891493214E-06 5.59131097099E-06 5.72691468449E-06 5.86580365108E-06 6.00805731988E-06 6.15375705554E-06 6.30298618424E-06 6.45583004067E-06 6.61237601625E-06 6.77271360838E-06 6.93693447095E-06 7.10513246599E-06 7.27740371658E-06 7.45384666098E-06 7.63456210809E-06 7.81965329422E-06 8.00922594110E-06 8.20338831548E-06 8.40225128987E-06 8.60592840499E-06 8.81453593345E-06 9.02819294514E-06 9.24702137402E-06 9.47114608657E-06 9.70069495182E-06 9.93579891303E-06 1.01765920611E-05 1.04232117097E-05 1.06757984721E-05 1.09344963399E-05 1.11994527635E-05 1.14708187348E-05 1.17487488710E-05 1.20334015018E-05 1.23249387571E-05 1.26235266578E-05 1.29293352082E-05 1.32425384908E-05 1.35633147637E-05 1.38918465591E-05 1.42283207853E-05 1.45729288310E-05 1.49258666708E-05 1.52873349750E-05 1.56575392201E-05 1.60366898038E-05 1.64250021608E-05 1.68226968825E-05 1.72299998394E-05 1.76471423058E-05 1.80743610878E-05 1.85118986540E-05 1.89600032698E-05 1.94189291343E-05 1.98889365200E-05 2.03702919172E-05 2.08632681797E-05 2.13681446757E-05 2.18852074414E-05 2.24147493376E-05 2.29570702110E-05 2.35124770586E-05 2.40812841958E-05 2.46638134289E-05 2.52603942307E-05 2.58713639211E-05 2.64970678512E-05 2.71378595916E-05 2.77941011256E-05 2.84661630462E-05 2.91544247577E-05 2.98592746822E-05 3.05811104706E-05 3.13203392181E-05 3.20773776856E-05 3.28526525247E-05 3.36466005089E-05 3.44596687696E-05 3.52923150378E-05 3.61450078903E-05 3.70182270028E-05 3.79124634078E-05 3.88282197582E-05 3.97660105977E-05 4.07263626364E-05 4.17098150329E-05 4.27169196826E-05 4.37482415130E-05 4.48043587845E-05 4.58858633991E-05 4.69933612149E-05 4.81274723684E-05 4.92888316035E-05 5.04780886078E-05 5.16959083566E-05 5.29429714641E-05 5.42199745428E-05 5.55276305702E-05 5.68666692640E-05 5.82378374654E-05 5.96418995309E-05 6.10796377320E-05 6.25518526647E-05 6.40593636667E-05 6.56030092447E-05 6.71836475101E-05 6.88021566244E-05 7.04594352545E-05 7.21564030375E-05 7.38940010551E-05 7.56731923187E-05 7.74949622649E-05 7.93603192606E-05 8.12702951201E-05 8.32259456322E-05 8.52283510989E-05 8.72786168851E-05 8.93778739798E-05 9.15272795698E-05 9.37280176242E-05 9.59812994920E-05 9.82883645115E-05 1.00650480633E-04 1.03068945052E-04 1.05545084860E-04 1.08080257705E-04 1.10675852464E-04 1.13333289934E-04 1.16054023534E-04 1.18839540021E-04 1.21691360221E-04 1.24611039774E-04 1.27600169896E-04 1.30660378153E-04 1.33793329253E-04 1.37000725852E-04 1.40284309375E-04 1.43645860855E-04 1.47087201787E-04 1.50610195002E-04 1.54216745549E-04 1.57908801603E-04 1.61688355386E-04 1.65557444107E-04 1.69518150918E-04 1.73572605887E-04 1.77722986995E-04 1.81971521141E-04 1.86320485178E-04 1.90772206954E-04 1.95329066389E-04 1.99993496550E-04 2.04767984766E-04 2.09655073748E-04 2.14657362736E-04 2.19777508665E-04 2.25018227348E-04 2.30382294681E-04 2.35872547872E-04 2.41491886685E-04 2.47243274708E-04 2.53129740640E-04 2.59154379603E-04 2.65320354468E-04 2.71630897211E-04 2.78089310283E-04 2.84698968005E-04 2.91463317984E-04 2.98385882551E-04 3.05470260218E-04 3.12720127161E-04 3.20139238720E-04 3.27731430922E-04 3.35500622029E-04 3.43450814103E-04 3.51586094591E-04 3.59910637940E-04 3.68428707223E-04 3.77144655791E-04 3.86062928946E-04 3.95188065630E-04 4.04524700145E-04 4.14077563877E-04 4.23851487054E-04 4.33851400516E-04 4.44082337506E-04 4.54549435476E-04 4.65257937920E-04 4.76213196212E-04 4.87420671472E-04 4.98885936439E-04 5.10614677371E-04 5.22612695943E-04 5.34885911178E-04 5.47440361379E-04 5.60282206073E-04 5.73417727977E-04 5.86853334958E-04 6.00595562022E-04 6.14651073289E-04 6.29026663996E-04 6.43729262490E-04 6.58765932229E-04 6.74143873793E-04 6.89870426886E-04 7.05953072341E-04 7.22399434122E-04 7.39217281326E-04 7.56414530169E-04 7.73999245973E-04 7.91979645138E-04 8.10364097100E-04 8.29161126272E-04 8.48379413977E-04 8.68027800342E-04 8.88115286189E-04 9.08651034881E-04 9.29644374150E-04 9.51104797887E-04 9.73041967897E-04 9.95465715608E-04 1.01838604375E-03 1.04181312796E-03 1.06575731837E-03 1.09022914112E-03 1.11523929977E-03 1.14079867675E-03 1.16691833463E-03 1.19360951734E-03 1.22088365139E-03 1.24875234689E-03 1.27722739854E-03 1.30632078650E-03 1.33604467719E-03 1.36641142390E-03 1.39743356739E-03 1.42912383624E-03 1.46149514718E-03 1.49456060521E-03 1.52833350359E-03 1.56282732365E-03 1.59805573451E-03 1.63403259251E-03 1.67077194052E-03 1.70828800709E-03 1.74659520533E-03 1.78570813156E-03 1.82564156383E-03 1.86641046014E-03 1.90802995635E-03 1.95051536397E-03 1.99388216757E-03 2.03814602193E-03 2.08332274891E-03 2.12942833399E-03 2.17647892247E-03 2.22449081538E-03 2.27348046495E-03 2.32346446982E-03 2.37445956973E-03 2.42648263994E-03 2.47955068512E-03 2.53368083286E-03 2.58889032672E-03 2.64519651880E-03 2.70261686178E-03 2.76116890053E-03 2.82087026311E-03 2.88173865124E-03 2.94379183026E-03 3.00704761835E-03 3.07152387531E-03 3.13723849059E-03 3.20420937066E-03 3.27245442577E-03 3.34199155592E-03 3.41283863613E-03 3.48501350101E-03 3.55853392844E-03 3.63341762253E-03 3.70968219571E-03 3.78734514997E-03 3.86642385723E-03 3.94693553877E-03 4.02889724374E-03 4.11232582670E-03 4.19723792415E-03 4.28364993009E-03 4.37157797045E-03 4.46103787653E-03 4.55204515722E-03 4.64461497026E-03 4.73876209210E-03 4.83450088683E-03 4.93184527365E-03 5.03080869328E-03 5.13140407298E-03 5.23364379030E-03 5.33753963554E-03 5.44310277279E-03 5.55034369964E-03 5.65927220545E-03 5.76989732822E-03 5.88222730998E-03 5.99626955074E-03 6.11203056088E-03 6.22951591212E-03 6.34873018686E-03 6.46967692606E-03 6.59235857544E-03 6.71677643027E-03 6.84293057837E-03 6.97081984174E-03 7.10044171634E-03 7.23179231052E-03 7.36486628164E-03 7.49965677119E-03 7.63615533834E-03 7.77435189181E-03 7.91423462025E-03 8.05578992104E-03 8.19900232757E-03 8.34385443501E-03 8.49032682461E-03 8.63839798656E-03 8.78804424153E-03 8.93923966074E-03 9.09195598489E-03 9.24616254176E-03 9.40182616275E-03 9.55891109826E-03 9.71737893212E-03 9.87718849518E-03 1.00382957780E-02 1.02006538429E-02 1.03642127354E-02 1.05289193956E-02 1.06947175684E-02 1.08615477146E-02 1.10293469212E-02 1.11980488125E-02 1.13675834610E-02 1.15378772994E-02 1.17088530333E-02 1.18804295542E-02 1.20525218549E-02 1.22250409456E-02 1.23978937716E-02 1.25709831342E-02 1.27442076124E-02 1.29174614884E-02 1.30906346756E-02 1.32636126501E-02 1.34362763855E-02 1.36085022925E-02 1.37801621622E-02 1.39511231149E-02 1.41212475535E-02 1.42903931235E-02 1.44584126785E-02 1.46251542530E-02 1.47904610417E-02 1.49541713871E-02 1.51161187754E-02 1.52761318406E-02 1.54340343786E-02 1.55896453711E-02 1.57427790198E-02 1.58932447919E-02 1.60408474781E-02 1.61853872615E-02 1.63266598011E-02 1.64644563287E-02 1.65985637594E-02 1.67287648181E-02 1.68548381820E-02 1.69765586383E-02 1.70936972605E-02 1.72060216018E-02 1.73132959073E-02 1.74152813452E-02 1.75117362582E-02 1.76024164353E-02 1.76870754048E-02 1.77654647496E-02 1.78373344438E-02 1.79024332136E-02 1.79605089212E-02 1.80113089727E-02 1.80545807504E-02 1.80900720708E-02 1.81175316672E-02 1.81367096978E-02 1.81473582810E-02 1.81492320551E-02 1.81420887651E-02 1.81256898760E-02 1.80998012113E-02 1.80641936183E-02 1.80186436589E-02 1.79629343255E-02 1.78968557819E-02 1.78202061286E-02 1.77327921915E-02 1.76344303328E-02 1.75249472839E-02 1.74041809985E-02 1.72719815245E-02 1.71282118933E-02 1.69727490253E-02 1.68054846481E-02 1.66263262275E-02 1.64351979070E-02 1.62320414547E-02 1.60168172139E-02 1.57895050552E-02 1.55501053261E-02 1.52986397957E-02 1.50351525898E-02 1.47597111139E-02 1.44724069581E-02 1.41733567818E-02 1.38627031717E-02 1.35406154698E-02 1.32072905652E-02 1.28629536456E-02 1.25078589025E-02 1.21422901844E-02 1.17665615921E-02 1.13810180119E-02 1.09860355771E-02 1.05820220556E-02 1.01694171542E-02 9.74869273477E-03 9.32035293542E-03 8.88493419011E-03 8.44300514037E-03 7.99516643257E-03 7.54205039457E-03 7.08432058530E-03 6.62267121139E-03 6.15782640494E-03 5.69053935686E-03 5.22159130052E-03 4.75179034075E-03 4.28197012390E-03 3.81298834475E-03 3.34572508701E-03 2.88108099448E-03 2.41997527081E-03 1.96334350630E-03 1.51213533127E-03 1.06731189615E-03 6.29843179474E-04 2.00705125932E-04 -2.19123382238E-04 -6.28663716296E-04 -1.02694084892E-03 -1.41298685235E-03 -1.78584453869E-03 -2.14457123320E-03 -2.48824266986E-03 -2.81595699729E-03 -3.12683888145E-03 -3.42004369055E-03 -3.69476174573E-03 -3.95022261998E-03 -4.18569946617E-03 -4.40051335385E-03 -4.59403759304E-03 -4.76570202196E-03 -4.91499723441E-03 -5.04147872148E-03 -5.14477090110E-03 -5.22457100794E-03 -5.28065281559E-03 -5.31287016185E-03 -5.32116024784E-03 -5.30554668086E-03 -5.26614223091E-03 -5.20315127068E-03 -5.11687186889E-03 -5.00769750730E-03 -4.87611839209E-03 -4.72272233127E-03 -4.54819515057E-03 -4.35332062143E-03 -4.13897987638E-03 -3.90615028835E-03 -3.65590379252E-03 -3.38940463142E-03 -3.10790650586E-03 -2.81274911728E-03 -2.50535408906E-03 -2.18722025766E-03 -1.85991832703E-03 -1.52508488274E-03 -1.18441576565E-03 -8.39658807964E-04 -4.92605937674E-04 -1.45084661016E-04 2.01051064466E-04 5.43930550164E-04 8.81676670683E-04 1.21241670966E-03 1.53429373151E-03 1.84547845042E-03 2.14418156505E-03 2.42866652442E-03 2.69726268794E-03 2.94837883983E-03 3.18051701573E-03 3.39228659692E-03 3.58241862541E-03 3.74978029086E-03 3.89338953814E-03 4.01242974248E-03 4.10626439670E-03 4.17445175334E-03 4.21675936192E-03 4.23317843951E-03 4.22393801029E-03 4.18951874714E-03 4.13066644529E-03 4.04840505522E-03 3.94404919786E-03 3.81921608190E-03 3.67583673799E-03 3.51616648002E-03 3.34279449777E-03 3.15865247940E-03 2.96702215455E-03 2.77154164149E-03 2.57566199023E-03 2.38089011443E-03 2.18823014809E-03 1.99869457853E-03 1.81329448384E-03 1.63302909648E-03 1.45887471256E-03 1.29177297210E-03 1.13261854162E-03 9.82246237055E-04 8.41417631543E-04 7.10807200168E-04 5.90988061164E-04 4.82417381159E-04 3.85421520440E-04 3.00181003021E-04 2.26715405545E-04 1.64868268686E-04 1.14292144793E-04 7.44339060435E-05 4.45204482804E-05 2.35449371168E-05 1.02537546470E-05 3.13431734147E-06 4.03948298162E-07 4.95620213881E-17 -1.02450617318E-17 -2.33666831254E-17 1.16323937007E-17 -1.39037946000E-17 1.82011653814E-17 1.04842216808E-17 1.82939481159E-17 1.90953596239E-17 -1.31979061302E-17 1.28763908493E-17 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2 2 0 i j (l(j)) -8.60401905508E-02 Q_int -1.34196693418E-06 -1.36361103804E-06 -1.38560423093E-06 -1.40795214315E-06 -1.43066049578E-06 -1.45373510219E-06 -1.47718186949E-06 -1.50100680009E-06 -1.52521599320E-06 -1.54981564637E-06 -1.57481205715E-06 -1.60021162463E-06 -1.62602085112E-06 -1.65224634379E-06 -1.67889481639E-06 -1.70597309092E-06 -1.73348809944E-06 -1.76144688579E-06 -1.78985660743E-06 -1.81872453725E-06 -1.84805806544E-06 -1.87786470137E-06 -1.90815207554E-06 -1.93892794150E-06 -1.97020017787E-06 -2.00197679032E-06 -2.03426591364E-06 -2.06707581383E-06 -2.10041489020E-06 -2.13429167752E-06 -2.16871484821E-06 -2.20369321457E-06 -2.23923573101E-06 -2.27535149638E-06 -2.31204975626E-06 -2.34933990534E-06 -2.38723148985E-06 -2.42573420996E-06 -2.46485792229E-06 -2.50461264244E-06 -2.54500854753E-06 -2.58605597882E-06 -2.62776544436E-06 -2.67014762167E-06 -2.71321336047E-06 -2.75697368547E-06 -2.80143979919E-06 -2.84662308483E-06 -2.89253510915E-06 -2.93918762549E-06 -2.98659257672E-06 -3.03476209836E-06 -3.08370852161E-06 -3.13344437657E-06 -3.18398239541E-06 -3.23533551567E-06 -3.28751688351E-06 -3.34053985714E-06 -3.39441801018E-06 -3.44916513519E-06 -3.50479524715E-06 -3.56132258708E-06 -3.61876162570E-06 -3.67712706706E-06 -3.73643385240E-06 -3.79669716391E-06 -3.85793242862E-06 -3.92015532239E-06 -3.98338177388E-06 -4.04762796864E-06 -4.11291035326E-06 -4.17924563958E-06 -4.24665080895E-06 -4.31514311659E-06 -4.38474009602E-06 -4.45545956352E-06 -4.52731962270E-06 -4.60033866915E-06 -4.67453539512E-06 -4.74992879433E-06 -4.82653816683E-06 -4.90438312390E-06 -4.98348359312E-06 -5.06385982345E-06 -5.14553239042E-06 -5.22852220138E-06 -5.31285050085E-06 -5.39853887598E-06 -5.48560926207E-06 -5.57408394816E-06 -5.66398558277E-06 -5.75533717965E-06 -5.84816212374E-06 -5.94248417706E-06 -6.03832748489E-06 -6.13571658189E-06 -6.23467639839E-06 -6.33523226677E-06 -6.43740992795E-06 -6.54123553798E-06 -6.64673567473E-06 -6.75393734469E-06 -6.86286798987E-06 -6.97355549485E-06 -7.08602819391E-06 -7.20031487825E-06 -7.31644480339E-06 -7.43444769666E-06 -7.55435376479E-06 -7.67619370164E-06 -7.79999869607E-06 -7.92580043990E-06 -8.05363113606E-06 -8.18352350678E-06 -8.31551080200E-06 -8.44962680787E-06 -8.58590585537E-06 -8.72438282916E-06 -8.86509317642E-06 -9.00807291601E-06 -9.15335864761E-06 -9.30098756114E-06 -9.45099744625E-06 -9.60342670200E-06 -9.75831434667E-06 -9.91570002776E-06 -1.00756240322E-05 -1.02381272964E-05 -1.04032514172E-05 -1.05710386619E-05 -1.07415319797E-05 -1.09147750123E-05 -1.10908121051E-05 -1.12696883186E-05 -1.14514494400E-05 -1.16361419948E-05 -1.18238132589E-05 -1.20145112704E-05 -1.22082848421E-05 -1.24051835739E-05 -1.26052578656E-05 -1.28085589296E-05 -1.30151388042E-05 -1.32250503670E-05 -1.34383473479E-05 -1.36550843435E-05 -1.38753168306E-05 -1.40991011808E-05 -1.43264946745E-05 -1.45575555158E-05 -1.47923428474E-05 -1.50309167656E-05 -1.52733383357E-05 -1.55196696078E-05 -1.57699736324E-05 -1.60243144769E-05 -1.62827572414E-05 -1.65453680761E-05 -1.68122141975E-05 -1.70833639062E-05 -1.73588866039E-05 -1.76388528114E-05 -1.79233341868E-05 -1.82124035432E-05 -1.85061348682E-05 -1.88046033420E-05 -1.91078853572E-05 -1.94160585382E-05 -1.97292017608E-05 -2.00473951727E-05 -2.03707202139E-05 -2.06992596373E-05 -2.10330975302E-05 -2.13723193357E-05 -2.17170118746E-05 -2.20672633672E-05 -2.24231634564E-05 -2.27848032306E-05 -2.31522752464E-05 -2.35256735529E-05 -2.39050937156E-05 -2.42906328406E-05 -2.46823895997E-05 -2.50804642554E-05 -2.54849586869E-05 -2.58959764156E-05 -2.63136226321E-05 -2.67380042228E-05 -2.71692297974E-05 -2.76074097165E-05 -2.80526561200E-05 -2.85050829554E-05 -2.89648060074E-05 -2.94319429275E-05 -2.99066132634E-05 -3.03889384905E-05 -3.08790420422E-05 -3.13770493418E-05 -3.18830878347E-05 -3.23972870205E-05 -3.29197784867E-05 -3.34506959418E-05 -3.39901752497E-05 -3.45383544646E-05 -3.50953738660E-05 -3.56613759947E-05 -3.62365056893E-05 -3.68209101228E-05 -3.74147388409E-05 -3.80181437997E-05 -3.86312794047E-05 -3.92543025501E-05 -3.98873726592E-05 -4.05306517250E-05 -4.11843043515E-05 -4.18484977956E-05 -4.25234020104E-05 -4.32091896882E-05 -4.39060363045E-05 -4.46141201632E-05 -4.53336224420E-05 -4.60647272385E-05 -4.68076216176E-05 -4.75624956590E-05 -4.83295425058E-05 -4.91089584139E-05 -4.99009428020E-05 -5.07056983028E-05 -5.15234308145E-05 -5.23543495534E-05 -5.31986671075E-05 -5.40565994906E-05 -5.49283661977E-05 -5.58141902607E-05 -5.67142983056E-05 -5.76289206103E-05 -5.85582911636E-05 -5.95026477244E-05 -6.04622318830E-05 -6.14372891225E-05 -6.24280688812E-05 -6.34348246169E-05 -6.44578138711E-05 -6.54972983348E-05 -6.65535439155E-05 -6.76268208048E-05 -6.87174035477E-05 -6.98255711121E-05 -7.09516069607E-05 -7.20957991227E-05 -7.32584402677E-05 -7.44398277800E-05 -7.56402638349E-05 -7.68600554755E-05 -7.80995146911E-05 -7.93589584966E-05 -8.06387090139E-05 -8.19390935533E-05 -8.32604446975E-05 -8.46031003864E-05 -8.59674040029E-05 -8.73537044608E-05 -8.87623562938E-05 -9.01937197455E-05 -9.16481608617E-05 -9.31260515833E-05 -9.46277698413E-05 -9.61536996533E-05 -9.77042312211E-05 -9.92797610301E-05 -1.00880691951E-04 -1.02507433340E-04 -1.04160401149E-04 -1.05840018022E-04 -1.07546713414E-04 -1.09280923691E-04 -1.11043092246E-04 -1.12833669612E-04 -1.14653113572E-04 -1.16501889283E-04 -1.18380469389E-04 -1.20289334142E-04 -1.22228971526E-04 -1.24199877381E-04 -1.26202555527E-04 -1.28237517896E-04 -1.30305284657E-04 -1.32406384353E-04 -1.34541354035E-04 -1.36710739395E-04 -1.38915094910E-04 -1.41154983978E-04 -1.43430979064E-04 -1.45743661847E-04 -1.48093623363E-04 -1.50481464162E-04 -1.52907794455E-04 -1.55373234269E-04 -1.57878413611E-04 -1.60423972621E-04 -1.63010561738E-04 -1.65638841865E-04 -1.68309484536E-04 -1.71023172088E-04 -1.73780597831E-04 -1.76582466231E-04 -1.79429493080E-04 -1.82322405684E-04 -1.85261943045E-04 -1.88248856050E-04 -1.91283907660E-04 -1.94367873104E-04 -1.97501540077E-04 -2.00685708939E-04 -2.03921192915E-04 -2.07208818308E-04 -2.10549424701E-04 -2.13943865175E-04 -2.17393006523E-04 -2.20897729470E-04 -2.24458928896E-04 -2.28077514065E-04 -2.31754408849E-04 -2.35490551971E-04 -2.39286897235E-04 -2.43144413770E-04 -2.47064086277E-04 -2.51046915276E-04 -2.55093917360E-04 -2.59206125453E-04 -2.63384589069E-04 -2.67630374578E-04 -2.71944565478E-04 -2.76328262667E-04 -2.80782584719E-04 -2.85308668171E-04 -2.89907667807E-04 -2.94580756951E-04 -2.99329127763E-04 -3.04153991538E-04 -3.09056579016E-04 -3.14038140687E-04 -3.19099947111E-04 -3.24243289238E-04 -3.29469478729E-04 -3.34779848291E-04 -3.40175752014E-04 -3.45658565706E-04 -3.51229687246E-04 -3.56890536931E-04 -3.62642557839E-04 -3.68487216185E-04 -3.74426001696E-04 -3.80460427983E-04 -3.86592032923E-04 -3.92822379042E-04 -3.99153053914E-04 -4.05585670552E-04 -4.12121867819E-04 -4.18763310839E-04 -4.25511691412E-04 -4.32368728439E-04 -4.39336168355E-04 -4.46415785566E-04 -4.53609382894E-04 -4.60918792028E-04 -4.68345873982E-04 -4.75892519564E-04 -4.83560649846E-04 -4.91352216646E-04 -4.99269203017E-04 -5.07313623741E-04 -5.15487525832E-04 -5.23792989051E-04 -5.32232126423E-04 -5.40807084761E-04 -5.49520045209E-04 -5.58373223779E-04 -5.67368871908E-04 -5.76509277016E-04 -5.85796763079E-04 -5.95233691203E-04 -6.04822460216E-04 -6.14565507261E-04 -6.24465308406E-04 -6.34524379252E-04 -6.44745275568E-04 -6.55130593917E-04 -6.65682972303E-04 -6.76405090825E-04 -6.87299672344E-04 -6.98369483150E-04 -7.09617333657E-04 -7.21046079090E-04 -7.32658620195E-04 -7.44457903955E-04 -7.56446924318E-04 -7.68628722935E-04 -7.81006389914E-04 -7.93583064577E-04 -8.06361936237E-04 -8.19346244982E-04 -8.32539282472E-04 -8.45944392749E-04 -8.59564973060E-04 -8.73404474689E-04 -8.87466403805E-04 -9.01754322323E-04 -9.16271848775E-04 -9.31022659199E-04 -9.46010488032E-04 -9.61239129033E-04 -9.76712436202E-04 -9.92434324724E-04 -1.00840877192E-03 -1.02463981823E-03 -1.04113156818E-03 -1.05788819138E-03 -1.07491392357E-03 -1.09221306760E-03 -1.10978999450E-03 -1.12764914456E-03 -1.14579502837E-03 -1.16423222792E-03 -1.18296539774E-03 -1.20199926596E-03 -1.22133863553E-03 -1.24098838530E-03 -1.26095347127E-03 -1.28123892772E-03 -1.30184986845E-03 -1.32279148802E-03 -1.34406906294E-03 -1.36568795302E-03 -1.38765360258E-03 -1.40997154177E-03 -1.43264738791E-03 -1.45568684682E-03 -1.47909571416E-03 -1.50287987684E-03 -1.52704531439E-03 -1.55159810040E-03 -1.57654440395E-03 -1.60189049105E-03 -1.62764272618E-03 -1.65380757370E-03 -1.68039159948E-03 -1.70740147235E-03 -1.73484396573E-03 -1.76272595919E-03 -1.79105444007E-03 -1.81983650511E-03 -1.84907936210E-03 -1.87879033160E-03 -1.90897684859E-03 -1.93964646423E-03 -1.97080684760E-03 -2.00246578748E-03 -2.03463119417E-03 -2.06731110128E-03 -2.10051366759E-03 -2.13424717895E-03 -2.16852005015E-03 -2.20334082688E-03 -2.23871818765E-03 -2.27466094578E-03 -2.31117805143E-03 -2.34827859362E-03 -2.38597180225E-03 -2.42426705025E-03 -2.46317385567E-03 -2.50270188382E-03 -2.54286094944E-03 -2.58366101891E-03 -2.62511221245E-03 -2.66722480644E-03 -2.71000923564E-03 -2.75347609554E-03 -2.79763614469E-03 -2.84250030709E-03 -2.88807967461E-03 -2.93438550937E-03 -2.98142924626E-03 -3.02922249542E-03 -3.07777704476E-03 -3.12710486252E-03 -3.17721809986E-03 -3.22812909351E-03 -3.27985036836E-03 -3.33239464022E-03 -3.38577481847E-03 -3.44000400884E-03 -3.49509551620E-03 -3.55106284734E-03 -3.60791971386E-03 -3.66568003500E-03 -3.72435794058E-03 -3.78396777393E-03 -3.84452409488E-03 -3.90604168274E-03 -3.96853553938E-03 -4.03202089227E-03 -4.09651319760E-03 -4.16202814341E-03 -4.22858165279E-03 -4.29618988704E-03 -4.36486924896E-03 -4.43463638606E-03 -4.50550819391E-03 -4.57750181945E-03 -4.65063466437E-03 -4.72492438851E-03 -4.80038891325E-03 -4.87704642504E-03 -4.95491537883E-03 -5.03401450162E-03 -5.11436279602E-03 -5.19597954382E-03 -5.27888430962E-03 -5.36309694445E-03 -5.44863758945E-03 -5.53552667960E-03 -5.62378494739E-03 -5.71343342663E-03 -5.80449345620E-03 -5.89698668387E-03 -5.99093507012E-03 -6.08636089203E-03 -6.18328674711E-03 -6.28173555725E-03 -6.38173057262E-03 -6.48329537563E-03 -6.58645388488E-03 -6.69123035915E-03 -6.79764940142E-03 -6.90573596286E-03 -7.01551534688E-03 -7.12701321318E-03 -7.24025558180E-03 -7.35526883719E-03 -7.47207973228E-03 -7.59071539260E-03 -7.71120332032E-03 -7.83357139838E-03 -7.95784789460E-03 -8.08406146572E-03 -8.21224116156E-03 -8.34241642904E-03 -8.47461711633E-03 -8.60887347688E-03 -8.74521617349E-03 -8.88367628234E-03 -9.02428529704E-03 -9.16707513265E-03 -9.31207812960E-03 -9.45932705772E-03 -9.60885512009E-03 -9.76069595702E-03 -9.91488364980E-03 -1.00714527246E-02 -1.02304381562E-02 -1.03918753717E-02 -1.05558002541E-02 -1.07222491462E-02 -1.08912588538E-02 -1.10628666492E-02 -1.12371102749E-02 -1.14140279466E-02 -1.15936583566E-02 -1.17760406769E-02 -1.19612145622E-02 -1.21492201531E-02 -1.23400980785E-02 -1.25338894586E-02 -1.27306359077E-02 -1.29303795360E-02 -1.31331629529E-02 -1.33390292682E-02 -1.35480220949E-02 -1.37601855505E-02 -1.39755642594E-02 -1.41942033534E-02 -1.44161484743E-02 -1.46414457738E-02 -1.48701419154E-02 -1.51022840745E-02 -1.53379199390E-02 -1.55770977101E-02 -1.58198661011E-02 -1.60662743386E-02 -1.63163721605E-02 -1.65702098162E-02 -1.68278380650E-02 -1.70893081747E-02 -1.73546719198E-02 -1.76239815793E-02 -1.78972899342E-02 -1.81746502647E-02 -1.84561163468E-02 -1.87417424488E-02 -1.90315833267E-02 -1.93256942203E-02 -1.96241308475E-02 -1.99269493991E-02 -2.02342065329E-02 -2.05459593667E-02 -2.08622654716E-02 -2.11831828640E-02 -2.15087699976E-02 -2.18390857543E-02 -2.21741894346E-02 -2.25141407477E-02 -2.28589998002E-02 -2.32088270848E-02 -2.35636834678E-02 -2.39236301760E-02 -2.42887287826E-02 -2.46590411926E-02 -2.50346296271E-02 -2.54155566066E-02 -2.58018849338E-02 -2.61936776749E-02 -2.65909981402E-02 -2.69939098639E-02 -2.74024765819E-02 -2.78167622100E-02 -2.82368308192E-02 -2.86627466115E-02 -2.90945738930E-02 -2.95323770467E-02 -2.99762205039E-02 -3.04261687134E-02 -3.08822861104E-02 -3.13446370834E-02 -3.18132859394E-02 -3.22882968681E-02 -3.27697339040E-02 -3.32576608868E-02 -3.37521414211E-02 -3.42532388328E-02 -3.47610161248E-02 -3.52755359305E-02 -3.57968604651E-02 -3.63250514757E-02 -3.68601701882E-02 -3.74022772531E-02 -3.79514326887E-02 -3.85076958218E-02 -3.90711252268E-02 -3.96417786619E-02 -4.02197130027E-02 -4.08049841740E-02 -4.13976470785E-02 -4.19977555226E-02 -4.26053621405E-02 -4.32205183144E-02 -4.38432740924E-02 -4.44736781034E-02 -4.51117774691E-02 -4.57576177125E-02 -4.64112426638E-02 -4.70726943627E-02 -4.77420129572E-02 -4.84192365999E-02 -4.91044013395E-02 -4.97975410099E-02 -5.04986871153E-02 -5.12078687112E-02 -5.19251122823E-02 -5.26504416162E-02 -5.33838776731E-02 -5.41254384515E-02 -5.48751388503E-02 -5.56329905261E-02 -5.63990017467E-02 -5.71731772402E-02 -5.79555180398E-02 -5.87460213243E-02 -5.95446802535E-02 -6.03514838005E-02 -6.11664165775E-02 -6.19894586590E-02 -6.28205853984E-02 -6.36597672417E-02 -6.45069695349E-02 -6.53621523279E-02 -6.62252701728E-02 -6.70962719176E-02 -6.79751004955E-02 -6.88616927086E-02 -6.97559790079E-02 -7.06578832671E-02 -7.15673225533E-02 -7.24842068916E-02 -7.34084390256E-02 -7.43399141739E-02 -7.52785197807E-02 -7.62241352634E-02 -7.71766317551E-02 -7.81358718428E-02 -7.91017093023E-02 -8.00739888287E-02 -8.10525457626E-02 -8.20372058141E-02 -8.30277847827E-02 -8.40240882736E-02 -8.50259114127E-02 -8.60330385576E-02 -8.70452430069E-02 -8.80622867081E-02 -8.90839199637E-02 -9.01098811354E-02 -9.11398963490E-02 -9.21736791983E-02 -9.32109304492E-02 -9.42513377449E-02 -9.52945753125E-02 -9.63403036714E-02 -9.73881693446E-02 -9.84378045727E-02 -9.94888270330E-02 -1.00540839562E-01 -1.01593429886E-01 -1.02646170355E-01 -1.03698617684E-01 -1.04750312710E-01 -1.05800780147E-01 -1.06849528359E-01 -1.07896049145E-01 -1.08939817529E-01 -1.09980291577E-01 -1.11016912215E-01 -1.12049103075E-01 -1.13076270352E-01 -1.14097802684E-01 -1.15113071052E-01 -1.16121428701E-01 -1.17122211088E-01 -1.18114735857E-01 -1.19098302832E-01 -1.20072194054E-01 -1.21035673838E-01 -1.21987988869E-01 -1.22928368328E-01 -1.23856024062E-01 -1.24770150786E-01 -1.25669926333E-01 -1.26554511941E-01 -1.27423052588E-01 -1.28274677381E-01 -1.29108499980E-01 -1.29923619091E-01 -1.30719119002E-01 -1.31494070176E-01 -1.32247529915E-01 -1.32978543064E-01 -1.33686142800E-01 -1.34369351471E-01 -1.35027181508E-01 -1.35658636409E-01 -1.36262711787E-01 -1.36838396502E-01 -1.37384673855E-01 -1.37900522874E-01 -1.38384919662E-01 -1.38836838838E-01 -1.39255255052E-01 -1.39639144585E-01 -1.39987487028E-01 -1.40299267052E-01 -1.40573476249E-01 -1.40809115071E-01 -1.41005194845E-01 -1.41160739869E-01 -1.41274789595E-01 -1.41346400894E-01 -1.41374650394E-01 -1.41358636897E-01 -1.41297483879E-01 -1.41190342047E-01 -1.41036391980E-01 -1.40834846818E-01 -1.40584955027E-01 -1.40286003204E-01 -1.39937318941E-01 -1.39538273725E-01 -1.39088285877E-01 -1.38586823517E-01 -1.38033407548E-01 -1.37427614652E-01 -1.36769080288E-01 -1.36057501671E-01 -1.35292640745E-01 -1.34474327109E-01 -1.33602460905E-01 -1.32677015650E-01 -1.31698040986E-01 -1.30665665349E-01 -1.29580098537E-01 -1.28441634155E-01 -1.27250651928E-01 -1.26007619862E-01 -1.24713096231E-01 -1.23367731388E-01 -1.21972269357E-01 -1.20527549210E-01 -1.19034506202E-01 -1.17494172639E-01 -1.15907678471E-01 -1.14276251586E-01 -1.12601217787E-01 -1.10884000436E-01 -1.09126119743E-01 -1.07329191697E-01 -1.05494926602E-01 -1.03625127222E-01 -1.01721686516E-01 -9.97865849462E-02 -9.78218873599E-02 -9.58297394229E-02 -9.38123636122E-02 -9.17720547552E-02 -8.97111751167E-02 -8.76321490349E-02 -8.55374571108E-02 -8.34296299572E-02 -8.13112415183E-02 -7.91849019745E-02 -7.70532502481E-02 -7.49189461335E-02 -7.27846620747E-02 -7.06530746218E-02 -6.85268555976E-02 -6.64086630131E-02 -6.43011317734E-02 -6.22068642196E-02 -6.01284205572E-02 -5.80683092243E-02 -5.60289772588E-02 -5.40128007255E-02 -5.20220752688E-02 -5.00590068597E-02 -4.81257028084E-02 -4.62241631169E-02 -4.43562722476E-02 -4.25237913858E-02 -4.07283512753E-02 -3.89714457053E-02 -3.72544257292E-02 -3.55784946925E-02 -3.39447041463E-02 -3.23539507206E-02 -3.08069740272E-02 -2.93043556593E-02 -2.78465193476E-02 -2.64337323284E-02 -2.50661079709E-02 -2.37436097020E-02 -2.24660562603E-02 -2.12331282975E-02 -2.00443763367E-02 -1.88992300825E-02 -1.77970090685E-02 -1.67369346084E-02 -1.57181430066E-02 -1.47396999667E-02 -1.38006161189E-02 -1.28998635714E-02 -1.20363933735E-02 -1.12091537581E-02 -1.04171090154E-02 -9.65925882693E-03 -8.93465787438E-03 -8.24243551521E-03 -7.58181529950E-03 -6.95213408371E-03 -6.35286047839E-03 -5.78361234940E-03 -5.24417307523E-03 -4.73450624716E-03 -4.25476848434E-03 -3.80532002290E-03 -3.38673272707E-03 -2.99945487282E-03 -2.64270737314E-03 -2.31535694469E-03 -2.01623745014E-03 -1.74415244215E-03 -1.49787782002E-03 -1.27616460446E-03 -1.07774183666E-03 -9.01319608706E-04 -7.45592232546E-04 -6.09241555814E-04 -4.90940432939E-04 -3.89356360634E-04 -3.03155287152E-04 -2.31005604927E-04 -1.71582336380E-04 -1.23571522558E-04 -8.56748241256E-05 -5.66143437399E-05 -3.51376782025E-05 -2.00232078406E-05 -1.00856293461E-05 -4.18173674128E-06 -1.21645322179E-06 -1.49114309720E-07 1.92399203934E-18 3.14275287546E-18 7.64167790561E-19 -1.80699588890E-18 -4.93324966098E-18 -2.28474004549E-18 -5.14060558166E-18 -7.72347382701E-20 4.04743210375E-18 2.31328510965E-18 4.33939936980E-19 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2 3 1 i j (l(j)) 0.00000000000E+00 Q_int -1.17834910416E-09 -1.20697142029E-09 -1.23628897513E-09 -1.26631865597E-09 -1.29707776032E-09 -1.32858400580E-09 -1.36085554043E-09 -1.39391095301E-09 -1.42776928387E-09 -1.46245003580E-09 -1.49797318532E-09 -1.53435919419E-09 -1.57162902115E-09 -1.60980413404E-09 -1.64890652211E-09 -1.68895870876E-09 -1.72998376446E-09 -1.77200532004E-09 -1.81504758032E-09 -1.85913533804E-09 -1.90429398814E-09 -1.95054954241E-09 -1.99792864443E-09 -2.04645858494E-09 -2.09616731757E-09 -2.14708347492E-09 -2.19923638506E-09 -2.25265608841E-09 -2.30737335508E-09 -2.36341970253E-09 -2.42082741380E-09 -2.47962955603E-09 -2.53985999955E-09 -2.60155343738E-09 -2.66474540521E-09 -2.72947230186E-09 -2.79577141025E-09 -2.86368091888E-09 -2.93323994381E-09 -3.00448855121E-09 -3.07746778042E-09 -3.15221966758E-09 -3.22878726987E-09 -3.30721469028E-09 -3.38754710302E-09 -3.46983077955E-09 -3.55411311522E-09 -3.64044265656E-09 -3.72886912925E-09 -3.81944346676E-09 -3.91221783969E-09 -4.00724568580E-09 -4.10458174079E-09 -4.20428206986E-09 -4.30640409994E-09 -4.41100665280E-09 -4.51814997895E-09 -4.62789579229E-09 -4.74030730568E-09 -4.85544926735E-09 -4.97338799817E-09 -5.09419142989E-09 -5.21792914420E-09 -5.34467241286E-09 -5.47449423872E-09 -5.60746939776E-09 -5.74367448217E-09 -5.88318794447E-09 -6.02609014265E-09 -6.17246338648E-09 -6.32239198495E-09 -6.47596229473E-09 -6.63326276999E-09 -6.79438401330E-09 -6.95941882783E-09 -7.12846227077E-09 -7.30161170809E-09 -7.47896687062E-09 -7.66062991147E-09 -7.84670546486E-09 -8.03730070640E-09 -8.23252541478E-09 -8.43249203501E-09 -8.63731574317E-09 -8.84711451275E-09 -9.06200918257E-09 -9.28212352638E-09 -9.50758432413E-09 -9.73852143500E-09 -9.97506787215E-09 -1.02173598794E-08 -1.04655370094E-08 -1.07197422046E-08 -1.09801218789E-08 -1.12468260023E-08 -1.15200081873E-08 -1.17998257771E-08 -1.20864399365E-08 -1.23800157447E-08 -1.26807222899E-08 -1.29887327674E-08 -1.33042245786E-08 -1.36273794337E-08 -1.39583834561E-08 -1.42974272897E-08 -1.46447062083E-08 -1.50004202286E-08 -1.53647742251E-08 -1.57379780479E-08 -1.61202466439E-08 -1.65118001801E-08 -1.69128641711E-08 -1.73236696080E-08 -1.77444530924E-08 -1.81754569717E-08 -1.86169294795E-08 -1.90691248777E-08 -1.95323036037E-08 -2.00067324197E-08 -2.04926845668E-08 -2.09904399220E-08 -2.15002851592E-08 -2.20225139150E-08 -2.25574269568E-08 -2.31053323567E-08 -2.36665456685E-08 -2.42413901096E-08 -2.48301967468E-08 -2.54333046872E-08 -2.60510612734E-08 -2.66838222831E-08 -2.73319521347E-08 -2.79958240962E-08 -2.86758205007E-08 -2.93723329664E-08 -3.00857626219E-08 -3.08165203373E-08 -3.15650269607E-08 -3.23317135603E-08 -3.31170216729E-08 -3.39214035576E-08 -3.47453224568E-08 -3.55892528623E-08 -3.64536807886E-08 -3.73391040530E-08 -3.82460325617E-08 -3.91749886037E-08 -4.01265071510E-08 -4.11011361671E-08 -4.20994369220E-08 -4.31219843157E-08 -4.41693672085E-08 -4.52421887605E-08 -4.63410667785E-08 -4.74666340718E-08 -4.86195388162E-08 -4.98004449272E-08 -5.10100324424E-08 -5.22489979122E-08 -5.35180548015E-08 -5.48179338997E-08 -5.61493837418E-08 -5.75131710388E-08 -5.89100811193E-08 -6.03409183812E-08 -6.18065067548E-08 -6.33076901769E-08 -6.48453330764E-08 -6.64203208721E-08 -6.80335604817E-08 -6.96859808443E-08 -7.13785334545E-08 -7.31121929100E-08 -7.48879574728E-08 -7.67068496431E-08 -7.85699167480E-08 -8.04782315440E-08 -8.24328928344E-08 -8.44350261015E-08 -8.64857841539E-08 -8.85863477903E-08 -9.07379264784E-08 -9.29417590511E-08 -9.51991144190E-08 -9.75112923007E-08 -9.98796239702E-08 -1.02305473023E-07 -1.04790236161E-07 -1.07335343994E-07 -1.09942261867E-07 -1.12612490698E-07 -1.15347567844E-07 -1.18149067985E-07 -1.21018604032E-07 -1.23957828051E-07 -1.26968432213E-07 -1.30052149772E-07 -1.33210756058E-07 -1.36446069500E-07 -1.39759952668E-07 -1.43154313352E-07 -1.46631105649E-07 -1.50192331097E-07 -1.53840039818E-07 -1.57576331701E-07 -1.61403357608E-07 -1.65323320614E-07 -1.69338477267E-07 -1.73451138894E-07 -1.77663672922E-07 -1.81978504246E-07 -1.86398116618E-07 -1.90925054078E-07 -1.95561922416E-07 -2.00311390667E-07 -2.05176192652E-07 -2.10159128542E-07 -2.15263066474E-07 -2.20490944195E-07 -2.25845770753E-07 -2.31330628226E-07 -2.36948673494E-07 -2.42703140052E-07 -2.48597339870E-07 -2.54634665293E-07 -2.60818590997E-07 -2.67152675979E-07 -2.73640565605E-07 -2.80285993705E-07 -2.87092784718E-07 -2.94064855889E-07 -3.01206219520E-07 -3.08520985274E-07 -3.16013362538E-07 -3.23687662839E-07 -3.31548302324E-07 -3.39599804290E-07 -3.47846801792E-07 -3.56294040294E-07 -3.64946380401E-07 -3.73808800648E-07 -3.82886400360E-07 -3.92184402580E-07 -4.01708157067E-07 -4.11463143369E-07 -4.21454973969E-07 -4.31689397508E-07 -4.42172302084E-07 -4.52909718631E-07 -4.63907824385E-07 -4.75172946427E-07 -4.86711565314E-07 -4.98530318800E-07 -5.10636005644E-07 -5.23035589513E-07 -5.35736202979E-07 -5.48745151608E-07 -5.62069918154E-07 -5.75718166853E-07 -5.89697747818E-07 -6.04016701544E-07 -6.18683263518E-07 -6.33705868944E-07 -6.49093157581E-07 -6.64853978698E-07 -6.80997396149E-07 -6.97532693567E-07 -7.14469379692E-07 -7.31817193819E-07 -7.49586111385E-07 -7.67786349681E-07 -7.86428373716E-07 -8.05522902209E-07 -8.25080913736E-07 -8.45113653021E-07 -8.65632637374E-07 -8.86649663298E-07 -9.08176813243E-07 -9.30226462525E-07 -9.52811286421E-07 -9.75944267425E-07 -9.99638702681E-07 -1.02390821160E-06 -1.04876674367E-06 -1.07422858642E-06 -1.10030837360E-06 -1.12702109360E-06 -1.15438209797E-06 -1.18240711024E-06 -1.21111223491E-06 -1.24051396668E-06 -1.27062919986E-06 -1.30147523805E-06 -1.33306980403E-06 -1.36543104991E-06 -1.39857756749E-06 -1.43252839893E-06 -1.46730304757E-06 -1.50292148915E-06 -1.53940418320E-06 -1.57677208470E-06 -1.61504665611E-06 -1.65424987960E-06 -1.69440426963E-06 -1.73553288577E-06 -1.77765934593E-06 -1.82080783979E-06 -1.86500314264E-06 -1.91027062954E-06 -1.95663628977E-06 -2.00412674168E-06 -2.05276924789E-06 -2.10259173082E-06 -2.15362278864E-06 -2.20589171158E-06 -2.25942849863E-06 -2.31426387464E-06 -2.37042930784E-06 -2.42795702777E-06 -2.48688004369E-06 -2.54723216333E-06 -2.60904801218E-06 -2.67236305322E-06 -2.73721360710E-06 -2.80363687283E-06 -2.87167094896E-06 -2.94135485525E-06 -3.01272855491E-06 -3.08583297729E-06 -3.16071004121E-06 -3.23740267876E-06 -3.31595485974E-06 -3.39641161664E-06 -3.47881907026E-06 -3.56322445588E-06 -3.64967615015E-06 -3.73822369849E-06 -3.82891784330E-06 -3.92181055275E-06 -4.01695505024E-06 -4.11440584464E-06 -4.21421876122E-06 -4.31645097328E-06 -4.42116103459E-06 -4.52840891259E-06 -4.63825602236E-06 -4.75076526145E-06 -4.86600104545E-06 -4.98402934455E-06 -5.10491772080E-06 -5.22873536641E-06 -5.35555314290E-06 -5.48544362114E-06 -5.61848112243E-06 -5.75474176048E-06 -5.89430348447E-06 -6.03724612303E-06 -6.18365142939E-06 -6.33360312749E-06 -6.48718695925E-06 -6.64449073296E-06 -6.80560437278E-06 -6.97061996949E-06 -7.13963183233E-06 -7.31273654222E-06 -7.49003300608E-06 -7.67162251258E-06 -7.85760878909E-06 -8.04809806010E-06 -8.24319910691E-06 -8.44302332882E-06 -8.64768480571E-06 -8.85730036212E-06 -9.07198963286E-06 -9.29187513014E-06 -9.51708231234E-06 -9.74773965428E-06 -9.98397871933E-06 -1.02259342331E-05 -1.04737441587E-05 -1.07275497745E-05 -1.09874957523E-05 -1.12537302392E-05 -1.15264049397E-05 -1.18056752008E-05 -1.20917000986E-05 -1.23846425271E-05 -1.26846692893E-05 -1.29919511896E-05 -1.33066631298E-05 -1.36289842058E-05 -1.39590978076E-05 -1.42971917214E-05 -1.46434582338E-05 -1.49980942386E-05 -1.53613013466E-05 -1.57332859968E-05 -1.61142595714E-05 -1.65044385130E-05 -1.69040444439E-05 -1.73133042896E-05 -1.77324504037E-05 -1.81617206968E-05 -1.86013587674E-05 -1.90516140370E-05 -1.95127418875E-05 -1.99850038015E-05 -2.04686675072E-05 -2.09640071251E-05 -2.14713033191E-05 -2.19908434506E-05 -2.25229217366E-05 -2.30678394108E-05 -2.36259048890E-05 -2.41974339382E-05 -2.47827498491E-05 -2.53821836132E-05 -2.59960741035E-05 -2.66247682598E-05 -2.72686212777E-05 -2.79279968022E-05 -2.86032671261E-05 -2.92948133918E-05 -3.00030257993E-05 -3.07283038172E-05 -3.14710564002E-05 -3.22317022100E-05 -3.30106698424E-05 -3.38083980589E-05 -3.46253360234E-05 -3.54619435452E-05 -3.63186913264E-05 -3.71960612151E-05 -3.80945464652E-05 -3.90146520006E-05 -3.99568946867E-05 -4.09218036071E-05 -4.19099203464E-05 -4.29217992806E-05 -4.39580078721E-05 -4.50191269728E-05 -4.61057511333E-05 -4.72184889190E-05 -4.83579632331E-05 -4.95248116471E-05 -5.07196867386E-05 -5.19432564358E-05 -5.31962043708E-05 -5.44792302395E-05 -5.57930501703E-05 -5.71383971003E-05 -5.85160211600E-05 -5.99266900661E-05 -6.13711895234E-05 -6.28503236349E-05 -6.43649153211E-05 -6.59158067481E-05 -6.75038597650E-05 -6.91299563515E-05 -7.07949990734E-05 -7.24999115500E-05 -7.42456389295E-05 -7.60331483759E-05 -7.78634295660E-05 -7.97374951962E-05 -8.16563815012E-05 -8.36211487825E-05 -8.56328819492E-05 -8.76926910688E-05 -8.98017119310E-05 -9.19611066221E-05 -9.41720641119E-05 -9.64358008527E-05 -9.87535613909E-05 -1.01126618991E-04 -1.03556276271E-04 -1.06043865854E-04 -1.08590751032E-04 -1.11198326441E-04 -1.13868018749E-04 -1.16601287365E-04 -1.19399625157E-04 -1.22264559179E-04 -1.25197651426E-04 -1.28200499590E-04 -1.31274737844E-04 -1.34422037627E-04 -1.37644108458E-04 -1.40942698758E-04 -1.44319596690E-04 -1.47776631015E-04 -1.51315671968E-04 -1.54938632140E-04 -1.58647467393E-04 -1.62444177777E-04 -1.66330808476E-04 -1.70309450762E-04 -1.74382242975E-04 -1.78551371515E-04 -1.82819071856E-04 -1.87187629578E-04 -1.91659381414E-04 -1.96236716323E-04 -2.00922076575E-04 -2.05717958859E-04 -2.10626915410E-04 -2.15651555156E-04 -2.20794544883E-04 -2.26058610425E-04 -2.31446537865E-04 -2.36961174768E-04 -2.42605431425E-04 -2.48382282121E-04 -2.54294766427E-04 -2.60345990510E-04 -2.66539128459E-04 -2.72877423644E-04 -2.79364190086E-04 -2.86002813852E-04 -2.92796754471E-04 -2.99749546374E-04 -3.06864800350E-04 -3.14146205027E-04 -3.21597528376E-04 -3.29222619232E-04 -3.37025408842E-04 -3.45009912424E-04 -3.53180230762E-04 -3.61540551810E-04 -3.70095152322E-04 -3.78848399500E-04 -3.87804752667E-04 -3.96968764958E-04 -4.06345085026E-04 -4.15938458776E-04 -4.25753731116E-04 -4.35795847722E-04 -4.46069856828E-04 -4.56580911029E-04 -4.67334269109E-04 -4.78335297874E-04 -4.89589474015E-04 -5.01102385979E-04 -5.12879735854E-04 -5.24927341274E-04 -5.37251137336E-04 -5.49857178526E-04 -5.62751640660E-04 -5.75940822838E-04 -5.89431149401E-04 -6.03229171906E-04 -6.17341571099E-04 -6.31775158902E-04 -6.46536880400E-04 -6.61633815833E-04 -6.77073182591E-04 -6.92862337207E-04 -7.09008777351E-04 -7.25520143818E-04 -7.42404222515E-04 -7.59668946436E-04 -7.77322397632E-04 -7.95372809165E-04 -8.13828567053E-04 -8.32698212197E-04 -8.51990442284E-04 -8.71714113678E-04 -8.91878243278E-04 -9.12492010350E-04 -9.33564758335E-04 -9.55105996611E-04 -9.77125402230E-04 -9.99632821601E-04 -1.02263827214E-03 -1.04615194386E-03 -1.07018420093E-03 -1.09474558311E-03 -1.11984680726E-03 -1.14549876861E-03 -1.17171254207E-03 -1.19849938348E-03 -1.22587073065E-03 -1.25383820447E-03 -1.28241360982E-03 -1.31160893641E-03 -1.34143635950E-03 -1.37190824057E-03 -1.40303712774E-03 -1.43483575624E-03 -1.46731704855E-03 -1.50049411458E-03 -1.53438025155E-03 -1.56898894382E-03 -1.60433386247E-03 -1.64042886479E-03 -1.67728799347E-03 -1.71492547571E-03 -1.75335572206E-03 -1.79259332504E-03 -1.83265305758E-03 -1.87354987116E-03 -1.91529889376E-03 -1.95791542748E-03 -2.00141494599E-03 -2.04581309158E-03 -2.09112567197E-03 -2.13736865681E-03 -2.18455817384E-03 -2.23271050472E-03 -2.28184208044E-03 -2.33196947651E-03 -2.38310940756E-03 -2.43527872172E-03 -2.48849439449E-03 -2.54277352213E-03 -2.59813331474E-03 -2.65459108871E-03 -2.71216425879E-03 -2.77087032958E-03 -2.83072688655E-03 -2.89175158647E-03 -2.95396214727E-03 -3.01737633735E-03 -3.08201196421E-03 -3.14788686254E-03 -3.21501888158E-03 -3.28342587180E-03 -3.35312567096E-03 -3.42413608934E-03 -3.49647489430E-03 -3.57015979404E-03 -3.64520842055E-03 -3.72163831177E-03 -3.79946689287E-03 -3.87871145668E-03 -3.95938914321E-03 -4.04151691825E-03 -4.12511155102E-03 -4.21018959083E-03 -4.29676734275E-03 -4.38486084225E-03 -4.47448582878E-03 -4.56565771824E-03 -4.65839157436E-03 -4.75270207897E-03 -4.84860350104E-03 -4.94610966458E-03 -5.04523391532E-03 -5.14598908610E-03 -5.24838746104E-03 -5.35244073841E-03 -5.45815999216E-03 -5.56555563212E-03 -5.67463736287E-03 -5.78541414116E-03 -5.89789413197E-03 -6.01208466317E-03 -6.12799217864E-03 -6.24562219007E-03 -6.36497922715E-03 -6.48606678638E-03 -6.60888727831E-03 -6.73344197332E-03 -6.85973094587E-03 -6.98775301721E-03 -7.11750569661E-03 -7.24898512104E-03 -7.38218599335E-03 -7.51710151896E-03 -7.65372334102E-03 -7.79204147408E-03 -7.93204423637E-03 -8.07371818057E-03 -8.21704802320E-03 -8.36201657261E-03 -8.50860465566E-03 -8.65679104312E-03 -8.80655237370E-03 -8.95786307707E-03 -9.11069529563E-03 -9.26501880519E-03 -9.42080093480E-03 -9.57800648553E-03 -9.73659764851E-03 -9.89653392227E-03 -1.00577720294E-02 -1.02202658328E-02 -1.03839662515E-02 -1.05488211763E-02 -1.07147753854E-02 -1.08817704597E-02 -1.10497446990E-02 -1.12186330383E-02 -1.13883669643E-02 -1.15588744333E-02 -1.17300797901E-02 -1.19019036879E-02 -1.20742630095E-02 -1.22470707911E-02 -1.24202361469E-02 -1.25936641973E-02 -1.27672559987E-02 -1.29409084769E-02 -1.31145143632E-02 -1.32879621344E-02 -1.34611359572E-02 -1.36339156357E-02 -1.38061765652E-02 -1.39777896896E-02 -1.41486214658E-02 -1.43185338330E-02 -1.44873841888E-02 -1.46550253728E-02 -1.48213056569E-02 -1.49860687434E-02 -1.51491537729E-02 -1.53103953393E-02 -1.54696235158E-02 -1.56266638904E-02 -1.57813376122E-02 -1.59334614490E-02 -1.60828478564E-02 -1.62293050602E-02 -1.63726371510E-02 -1.65126441930E-02 -1.66491223472E-02 -1.67818640091E-02 -1.69106579629E-02 -1.70352895506E-02 -1.71555408595E-02 -1.72711909261E-02 -1.73820159585E-02 -1.74877895776E-02 -1.75882830775E-02 -1.76832657058E-02 -1.77725049646E-02 -1.78557669318E-02 -1.79328166052E-02 -1.80034182668E-02 -1.80673358710E-02 -1.81243334551E-02 -1.81741755723E-02 -1.82166277492E-02 -1.82514569662E-02 -1.82784321619E-02 -1.82973247618E-02 -1.83079092301E-02 -1.83099636465E-02 -1.83032703060E-02 -1.82876163422E-02 -1.82627943744E-02 -1.82286031771E-02 -1.81848483713E-02 -1.81313431378E-02 -1.80679089513E-02 -1.79943763335E-02 -1.79105856258E-02 -1.78163877786E-02 -1.77116451567E-02 -1.75962323600E-02 -1.74700370552E-02 -1.73329608202E-02 -1.71849199954E-02 -1.70258465429E-02 -1.68556889081E-02 -1.66744128837E-02 -1.64820024717E-02 -1.62784607398E-02 -1.60638106711E-02 -1.58380960012E-02 -1.56013820403E-02 -1.53537564760E-02 -1.50953301532E-02 -1.48262378253E-02 -1.45466388747E-02 -1.42567179945E-02 -1.39566858303E-02 -1.36467795732E-02 -1.33272635025E-02 -1.29984294695E-02 -1.26605973184E-02 -1.23141152398E-02 -1.19593600479E-02 -1.15967373792E-02 -1.12266818044E-02 -1.08496568485E-02 -1.04661549133E-02 -1.00766970968E-02 -9.68183290324E-03 -9.28213983804E-03 -8.87822288336E-03 -8.47071384785E-03 -8.06027058626E-03 -7.64757608412E-03 -7.23333740323E-03 -6.81828448393E-03 -6.40316880079E-03 -5.98876186885E-03 -5.57585359783E-03 -5.16525049279E-03 -4.75777370000E-03 -4.35425689780E-03 -3.95554403286E-03 -3.56248690326E-03 -3.17594259052E-03 -2.79677074390E-03 -2.42583072116E-03 -2.06397859111E-03 -1.71206400430E-03 -1.37092693961E-03 -1.04139433535E-03 -7.24276614894E-04 -4.20364118207E-04 -1.30423451717E-04 1.44806229684E-04 4.04616993400E-04 6.48335936312E-04 8.75329010803E-04 1.08500485078E-03 1.27681857774E-03 1.45027556573E-03 1.60493514300E-03 1.74041420726E-03 1.85639073032E-03 1.95260712746E-03 2.02887346582E-03 2.08507048574E-03 2.12115240867E-03 2.13714950471E-03 2.13317039307E-03 2.10940404860E-03 2.06612148774E-03 2.00367710808E-03 1.92250965577E-03 1.82314279640E-03 1.70618526560E-03 1.57233057724E-03 1.42235626812E-03 1.25712266018E-03 1.07757112262E-03 8.84721818718E-04 6.79670924205E-04 4.63587306320E-04 2.37708655387E-04 3.33706326141E-06 -2.38165954207E-04 -4.85384990674E-04 -7.36856835864E-04 -9.91077109278E-04 -1.24650743221E-03 -1.50158312617E-03 -1.75472142297E-03 -2.00433016864E-03 -2.24881700079E-03 -2.48659897601E-03 -2.71611262150E-03 -2.93582438242E-03 -3.14424143445E-03 -3.33992282827E-03 -3.52149093128E-03 -3.68764312927E-03 -3.83716374955E-03 -3.96893616490E-03 -4.08195503623E-03 -4.17533865049E-03 -4.24834130828E-03 -4.30036571449E-03 -4.33097532340E-03 -4.33990658749E-03 -4.32708105755E-03 -4.29261727876E-03 -4.23684242471E-03 -4.16030360784E-03 -4.06377880065E-03 -3.94828729748E-03 -3.81509964053E-03 -3.66574692795E-03 -3.50202941321E-03 -3.32602429705E-03 -3.14009260224E-03 -2.94688501047E-03 -2.74934652679E-03 -2.55071982273E-03 -2.35407133482E-03 -2.16076409394E-03 -1.97170493391E-03 -1.78778623001E-03 -1.60987614150E-03 -1.43880849530E-03 -1.27537237722E-03 -1.12030150623E-03 -9.74263477264E-04 -8.37848967651E-04 -7.11561012906E-04 -5.95804467970E-04 -4.90875780845E-04 -3.96953216396E-04 -3.14087679090E-04 -2.42194294343E-04 -1.81044919004E-04 -1.30261762121E-04 -8.93123074390E-05 -5.75057389679E-05 -3.39910802470E-05 -1.77572665254E-05 -7.63537677275E-06 -2.30325909136E-06 -2.92788496871E-07 4.80251766208E-18 1.04747176272E-17 2.81180652248E-18 2.92870052897E-19 2.97269309251E-18 -7.29353984575E-18 2.25415417158E-18 7.79702874678E-18 -1.03208861459E-17 -1.22014760501E-17 -1.22781004454E-17 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2 4 1 i j (l(j)) 0.00000000000E+00 Q_int -9.45093278098E-10 -9.68049761423E-10 -9.91563859605E-10 -1.01564911706E-09 -1.04031940721E-09 -1.06558894044E-09 -1.09147227230E-09 -1.11798431189E-09 -1.14514033046E-09 -1.17295597019E-09 -1.20144725318E-09 -1.23063059072E-09 -1.26052279272E-09 -1.29114107739E-09 -1.32250308117E-09 -1.35462686887E-09 -1.38753094410E-09 -1.42123425989E-09 -1.45575622966E-09 -1.49111673835E-09 -1.52733615390E-09 -1.56443533897E-09 -1.60243566298E-09 -1.64135901438E-09 -1.68122781329E-09 -1.72206502440E-09 -1.76389417019E-09 -1.80673934449E-09 -1.85062522635E-09 -1.89557709428E-09 -1.94162084075E-09 -1.98878298716E-09 -2.03709069911E-09 -2.08657180200E-09 -2.13725479712E-09 -2.18916887800E-09 -2.24234394730E-09 -2.29681063394E-09 -2.35260031084E-09 -2.40974511290E-09 -2.46827795560E-09 -2.52823255384E-09 -2.58964344149E-09 -2.65254599118E-09 -2.71697643470E-09 -2.78297188391E-09 -2.85057035205E-09 -2.91981077567E-09 -2.99073303706E-09 -3.06337798720E-09 -3.13778746929E-09 -3.21400434287E-09 -3.29207250849E-09 -3.37203693297E-09 -3.45394367535E-09 -3.53783991337E-09 -3.62377397068E-09 -3.71179534464E-09 -3.80195473483E-09 -3.89430407227E-09 -3.98889654930E-09 -4.08578665027E-09 -4.18503018282E-09 -4.28668431014E-09 -4.39080758379E-09 -4.49745997748E-09 -4.60670292160E-09 -4.71859933856E-09 -4.83321367910E-09 -4.95061195934E-09 -5.07086179884E-09 -5.19403245951E-09 -5.32019488553E-09 -5.44942174421E-09 -5.58178746779E-09 -5.71736829637E-09 -5.85624232176E-09 -5.99848953248E-09 -6.14419185985E-09 -6.29343322512E-09 -6.44629958782E-09 -6.60287899530E-09 -6.76326163336E-09 -6.92753987828E-09 -7.09580834991E-09 -7.26816396627E-09 -7.44470599928E-09 -7.62553613196E-09 -7.81075851698E-09 -8.00047983665E-09 -8.19480936434E-09 -8.39385902742E-09 -8.59774347169E-09 -8.80658012744E-09 -9.02048927702E-09 -9.23959412415E-09 -9.46402086486E-09 -9.69389876011E-09 -9.92936021031E-09 -1.01705408315E-08 -1.04175795334E-08 -1.06706185995E-08 -1.09298037691E-08 -1.11952843207E-08 -1.14672131587E-08 -1.17457469010E-08 -1.20310459690E-08 -1.23232746806E-08 -1.26226013443E-08 -1.29291983562E-08 -1.32432422994E-08 -1.35649140455E-08 -1.38943988591E-08 -1.42318865040E-08 -1.45775713528E-08 -1.49316524987E-08 -1.52943338699E-08 -1.56658243477E-08 -1.60463378860E-08 -1.64360936349E-08 -1.68353160669E-08 -1.72442351057E-08 -1.76630862593E-08 -1.80921107550E-08 -1.85315556786E-08 -1.89816741163E-08 -1.94427253011E-08 -1.99149747612E-08 -2.03986944735E-08 -2.08941630198E-08 -2.14016657475E-08 -2.19214949338E-08 -2.24539499536E-08 -2.29993374523E-08 -2.35579715224E-08 -2.41301738836E-08 -2.47162740690E-08 -2.53166096141E-08 -2.59315262512E-08 -2.65613781088E-08 -2.72065279151E-08 -2.78673472068E-08 -2.85442165433E-08 -2.92375257255E-08 -2.99476740202E-08 -3.06750703899E-08 -3.14201337284E-08 -3.21832931018E-08 -3.29649879956E-08 -3.37656685673E-08 -3.45857959059E-08 -3.54258422973E-08 -3.62862914957E-08 -3.71676390026E-08 -3.80703923518E-08 -3.89950714011E-08 -3.99422086323E-08 -4.09123494570E-08 -4.19060525308E-08 -4.29238900748E-08 -4.39664482048E-08 -4.50343272689E-08 -4.61281421926E-08 -4.72485228332E-08 -4.83961143417E-08 -4.95715775346E-08 -5.07755892739E-08 -5.20088428566E-08 -5.32720484138E-08 -5.45659333192E-08 -5.58912426078E-08 -5.72487394046E-08 -5.86392053635E-08 -6.00634411173E-08 -6.15222667384E-08 -6.30165222106E-08 -6.45470679123E-08 -6.61147851116E-08 -6.77205764735E-08 -6.93653665791E-08 -7.10501024573E-08 -7.27757541304E-08 -7.45433151712E-08 -7.63538032754E-08 -7.82082608467E-08 -8.01077555965E-08 -8.20533811581E-08 -8.40462577159E-08 -8.60875326499E-08 -8.81783811953E-08 -9.03200071190E-08 -9.25136434116E-08 -9.47605529969E-08 -9.70620294583E-08 -9.94193977824E-08 -1.01834015122E-07 -1.04307271574E-07 -1.06840590985E-07 -1.09435431762E-07 -1.12093287717E-07 -1.14815688924E-07 -1.17604202599E-07 -1.20460434001E-07 -1.23386027357E-07 -1.26382666804E-07 -1.29452077360E-07 -1.32596025915E-07 -1.35816322247E-07 -1.39114820063E-07 -1.42493418064E-07 -1.45954061035E-07 -1.49498740969E-07 -1.53129498204E-07 -1.56848422602E-07 -1.60657654748E-07 -1.64559387181E-07 -1.68555865652E-07 -1.72649390419E-07 -1.76842317567E-07 -1.81137060361E-07 -1.85536090634E-07 -1.90041940207E-07 -1.94657202347E-07 -1.99384533251E-07 -2.04226653580E-07 -2.09186350015E-07 -2.14266476863E-07 -2.19469957696E-07 -2.24799787030E-07 -2.30259032044E-07 -2.35850834347E-07 -2.41578411776E-07 -2.47445060251E-07 -2.53454155661E-07 -2.59609155812E-07 -2.65913602405E-07 -2.72371123075E-07 -2.78985433471E-07 -2.85760339392E-07 -2.92699738975E-07 -2.99807624926E-07 -3.07088086820E-07 -3.14545313444E-07 -3.22183595206E-07 -3.30007326596E-07 -3.38021008707E-07 -3.46229251822E-07 -3.54636778061E-07 -3.63248424085E-07 -3.72069143881E-07 -3.81104011598E-07 -3.90358224461E-07 -3.99837105757E-07 -4.09546107883E-07 -4.19490815479E-07 -4.29676948633E-07 -4.40110366156E-07 -4.50797068953E-07 -4.61743203455E-07 -4.72955065152E-07 -4.84439102200E-07 -4.96201919119E-07 -5.08250280584E-07 -5.20591115299E-07 -5.33231519973E-07 -5.46178763387E-07 -5.59440290564E-07 -5.73023727034E-07 -5.86936883205E-07 -6.01187758842E-07 -6.15784547648E-07 -6.30735641965E-07 -6.46049637576E-07 -6.61735338636E-07 -6.77801762713E-07 -6.94258145957E-07 -7.11113948383E-07 -7.28378859301E-07 -7.46062802853E-07 -7.64175943707E-07 -7.82728692868E-07 -8.01731713646E-07 -8.21195927756E-07 -8.41132521573E-07 -8.61552952533E-07 -8.82468955690E-07 -9.03892550434E-07 -9.25836047364E-07 -9.48312055338E-07 -9.71333488679E-07 -9.94913574566E-07 -1.01906586060E-06 -1.04380422255E-06 -1.06914287228E-06 -1.09509636590E-06 -1.12167961204E-06 -1.14890788044E-06 -1.17679681060E-06 -1.20536242079E-06 -1.23462111713E-06 -1.26458970303E-06 -1.29528538876E-06 -1.32672580126E-06 -1.35892899425E-06 -1.39191345848E-06 -1.42569813237E-06 -1.46030241272E-06 -1.49574616587E-06 -1.53204973899E-06 -1.56923397169E-06 -1.60732020792E-06 -1.64633030815E-06 -1.68628666183E-06 -1.72721220015E-06 -1.76913040913E-06 -1.81206534298E-06 -1.85604163785E-06 -1.90108452582E-06 -1.94721984933E-06 -1.99447407585E-06 -2.04287431299E-06 -2.09244832390E-06 -2.14322454312E-06 -2.19523209273E-06 -2.24850079895E-06 -2.30306120908E-06 -2.35894460889E-06 -2.41618304044E-06 -2.47480932027E-06 -2.53485705804E-06 -2.59636067569E-06 -2.65935542696E-06 -2.72387741743E-06 -2.78996362501E-06 -2.85765192097E-06 -2.92698109145E-06 -2.99799085941E-06 -3.07072190725E-06 -3.14521589984E-06 -3.22151550819E-06 -3.29966443360E-06 -3.37970743249E-06 -3.46169034173E-06 -3.54566010462E-06 -3.63166479747E-06 -3.71975365688E-06 -3.80997710753E-06 -3.90238679080E-06 -3.99703559396E-06 -4.09397768005E-06 -4.19326851857E-06 -4.29496491683E-06 -4.39912505200E-06 -4.50580850404E-06 -4.61507628933E-06 -4.72699089512E-06 -4.84161631479E-06 -4.95901808398E-06 -5.07926331754E-06 -5.20242074740E-06 -5.32856076126E-06 -5.45775544231E-06 -5.59007860979E-06 -5.72560586059E-06 -5.86441461177E-06 -6.00658414412E-06 -6.15219564677E-06 -6.30133226282E-06 -6.45407913607E-06 -6.61052345886E-06 -6.77075452098E-06 -6.93486375986E-06 -7.10294481183E-06 -7.27509356462E-06 -7.45140821113E-06 -7.63198930446E-06 -7.81693981420E-06 -8.00636518408E-06 -8.20037339097E-06 -8.39907500525E-06 -8.60258325267E-06 -8.81101407754E-06 -9.02448620752E-06 -9.24312121989E-06 -9.46704360934E-06 -9.69638085742E-06 -9.93126350355E-06 -1.01718252177E-05 -1.04182028750E-05 -1.06705366315E-05 -1.09289700024E-05 -1.11936499418E-05 -1.14647269241E-05 -1.17423550278E-05 -1.20266920207E-05 -1.23178994474E-05 -1.26161427190E-05 -1.29215912044E-05 -1.32344183244E-05 -1.35548016470E-05 -1.38829229859E-05 -1.42189685009E-05 -1.45631288006E-05 -1.49155990471E-05 -1.52765790641E-05 -1.56462734466E-05 -1.60248916734E-05 -1.64126482224E-05 -1.68097626884E-05 -1.72164599034E-05 -1.76329700602E-05 -1.80595288384E-05 -1.84963775334E-05 -1.89437631883E-05 -1.94019387291E-05 -1.98711631029E-05 -2.03517014189E-05 -2.08438250928E-05 -2.13478119953E-05 -2.18639466024E-05 -2.23925201506E-05 -2.29338307948E-05 -2.34881837703E-05 -2.40558915577E-05 -2.46372740528E-05 -2.52326587387E-05 -2.58423808637E-05 -2.64667836213E-05 -2.71062183358E-05 -2.77610446513E-05 -2.84316307250E-05 -2.91183534252E-05 -2.98215985332E-05 -3.05417609505E-05 -3.12792449095E-05 -3.20344641904E-05 -3.28078423415E-05 -3.35998129053E-05 -3.44108196496E-05 -3.52413168028E-05 -3.60917692960E-05 -3.69626530089E-05 -3.78544550221E-05 -3.87676738749E-05 -3.97028198280E-05 -4.06604151333E-05 -4.16409943079E-05 -4.26451044162E-05 -4.36733053560E-05 -4.47261701525E-05 -4.58042852579E-05 -4.69082508578E-05 -4.80386811836E-05 -4.91962048332E-05 -5.03814650965E-05 -5.15951202899E-05 -5.28378440967E-05 -5.41103259151E-05 -5.54132712144E-05 -5.67474018972E-05 -5.81134566712E-05 -5.95121914275E-05 -6.09443796272E-05 -6.24108126969E-05 -6.39123004316E-05 -6.54496714064E-05 -6.70237733971E-05 -6.86354738092E-05 -7.02856601160E-05 -7.19752403058E-05 -7.37051433381E-05 -7.54763196100E-05 -7.72897414308E-05 -7.91464035079E-05 -8.10473234414E-05 -8.29935422295E-05 -8.49861247835E-05 -8.70261604541E-05 -8.91147635672E-05 -9.12530739713E-05 -9.34422575955E-05 -9.56835070184E-05 -9.79780420489E-05 -1.00327110317E-04 -1.02731987880E-04 -1.05193979832E-04 -1.07714420937E-04 -1.10294676267E-04 -1.12936141849E-04 -1.15640245335E-04 -1.18408446675E-04 -1.21242238809E-04 -1.24143148365E-04 -1.27112736380E-04 -1.30152599027E-04 -1.33264368356E-04 -1.36449713051E-04 -1.39710339201E-04 -1.43047991082E-04 -1.46464451957E-04 -1.49961544886E-04 -1.53541133554E-04 -1.57205123113E-04 -1.60955461036E-04 -1.64794137989E-04 -1.68723188718E-04 -1.72744692946E-04 -1.76860776293E-04 -1.81073611206E-04 -1.85385417905E-04 -1.89798465348E-04 -1.94315072205E-04 -1.98937607854E-04 -2.03668493393E-04 -2.08510202658E-04 -2.13465263274E-04 -2.18536257704E-04 -2.23725824326E-04 -2.29036658520E-04 -2.34471513777E-04 -2.40033202814E-04 -2.45724598718E-04 -2.51548636092E-04 -2.57508312230E-04 -2.63606688296E-04 -2.69846890530E-04 -2.76232111456E-04 -2.82765611123E-04 -2.89450718343E-04 -2.96290831958E-04 -3.03289422113E-04 -3.10450031550E-04 -3.17776276911E-04 -3.25271850060E-04 -3.32940519416E-04 -3.40786131300E-04 -3.48812611292E-04 -3.57023965610E-04 -3.65424282491E-04 -3.74017733587E-04 -3.82808575375E-04 -3.91801150578E-04 -4.00999889588E-04 -4.10409311909E-04 -4.20034027602E-04 -4.29878738742E-04 -4.39948240875E-04 -4.50247424494E-04 -4.60781276508E-04 -4.71554881719E-04 -4.82573424308E-04 -4.93842189318E-04 -5.05366564137E-04 -5.17152039986E-04 -5.29204213401E-04 -5.41528787718E-04 -5.54131574543E-04 -5.67018495232E-04 -5.80195582350E-04 -5.93668981126E-04 -6.07444950902E-04 -6.21529866561E-04 -6.35930219945E-04 -6.50652621257E-04 -6.65703800441E-04 -6.81090608544E-04 -6.96820019054E-04 -7.12899129208E-04 -7.29335161276E-04 -7.46135463814E-04 -7.63307512875E-04 -7.80858913194E-04 -7.98797399322E-04 -8.17130836723E-04 -8.35867222818E-04 -8.55014687986E-04 -8.74581496499E-04 -8.94576047411E-04 -9.15006875372E-04 -9.35882651385E-04 -9.57212183483E-04 -9.79004417337E-04 -1.00126843678E-03 -1.02401346424E-03 -1.04724886108E-03 -1.07098412788E-03 -1.09522890452E-03 -1.11999297031E-03 -1.14528624381E-03 -1.17111878270E-03 -1.19750078345E-03 -1.22444258084E-03 -1.25195464736E-03 -1.28004759247E-03 -1.30873216170E-03 -1.33801923555E-03 -1.36791982828E-03 -1.39844508647E-03 -1.42960628739E-03 -1.46141483723E-03 -1.49388226902E-03 -1.52702024044E-03 -1.56084053131E-03 -1.59535504093E-03 -1.63057578508E-03 -1.66651489283E-03 -1.70318460304E-03 -1.74059726059E-03 -1.77876531234E-03 -1.81770130272E-03 -1.85741786906E-03 -1.89792773656E-03 -1.93924371290E-03 -1.98137868254E-03 -2.02434560059E-03 -2.06815748629E-03 -2.11282741616E-03 -2.15836851664E-03 -2.20479395633E-03 -2.25211693782E-03 -2.30035068896E-03 -2.34950845373E-03 -2.39960348258E-03 -2.45064902224E-03 -2.50265830498E-03 -2.55564453737E-03 -2.60962088841E-03 -2.66460047708E-03 -2.72059635930E-03 -2.77762151424E-03 -2.83568882997E-03 -2.89481108849E-03 -2.95500094996E-03 -3.01627093635E-03 -3.07863341425E-03 -3.14210057701E-03 -3.20668442601E-03 -3.27239675126E-03 -3.33924911101E-03 -3.40725281074E-03 -3.47641888106E-03 -3.54675805490E-03 -3.61828074375E-03 -3.69099701288E-03 -3.76491655580E-03 -3.84004866755E-03 -3.91640221719E-03 -3.99398561914E-03 -4.07280680355E-03 -4.15287318566E-03 -4.23419163404E-03 -4.31676843774E-03 -4.40060927240E-03 -4.48571916522E-03 -4.57210245873E-03 -4.65976277353E-03 -4.74870296979E-03 -4.83892510757E-03 -4.93043040605E-03 -5.02321920142E-03 -5.11729090372E-03 -5.21264395236E-03 -5.30927577053E-03 -5.40718271826E-03 -5.50636004443E-03 -5.60680183746E-03 -5.70850097482E-03 -5.81144907135E-03 -5.91563642643E-03 -6.02105196991E-03 -6.12768320696E-03 -6.23551616170E-03 -6.34453531983E-03 -6.45472357011E-03 -6.56606214478E-03 -6.67853055906E-03 -6.79210654959E-03 -6.90676601203E-03 -7.02248293775E-03 -7.13922934972E-03 -7.25697523770E-03 -7.37568849269E-03 -7.49533484089E-03 -7.61587777706E-03 -7.73727849749E-03 -7.85949583272E-03 -7.98248617993E-03 -8.10620343536E-03 -8.23059892666E-03 -8.35562134549E-03 -8.48121668032E-03 -8.60732814978E-03 -8.73389613657E-03 -8.86085812218E-03 -8.98814862253E-03 -9.11569912485E-03 -9.24343802584E-03 -9.37129057142E-03 -9.49917879835E-03 -9.62702147779E-03 -9.75473406121E-03 -9.88222862886E-03 -1.00094138410E-02 -1.01361948923E-02 -1.02624734697E-02 -1.03881477140E-02 -1.05131121851E-02 -1.06372578326E-02 -1.07604719699E-02 -1.08826382547E-02 -1.10036366739E-02 -1.11233435352E-02 -1.12416314644E-02 -1.13583694100E-02 -1.14734226545E-02 -1.15866528336E-02 -1.16979179633E-02 -1.18070724755E-02 -1.19139672627E-02 -1.20184497323E-02 -1.21203638709E-02 -1.22195503183E-02 -1.23158464540E-02 -1.24090864941E-02 -1.24991016002E-02 -1.25857200017E-02 -1.26687671304E-02 -1.27480657693E-02 -1.28234362151E-02 -1.28946964554E-02 -1.29616623614E-02 -1.30241478962E-02 -1.30819653387E-02 -1.31349255251E-02 -1.31828381065E-02 -1.32255118248E-02 -1.32627548061E-02 -1.32943748727E-02 -1.33201798735E-02 -1.33399780338E-02 -1.33535783239E-02 -1.33607908479E-02 -1.33614272512E-02 -1.33553011489E-02 -1.33422285738E-02 -1.33220284436E-02 -1.32945230493E-02 -1.32595385620E-02 -1.32169055605E-02 -1.31664595774E-02 -1.31080416640E-02 -1.30414989741E-02 -1.29666853654E-02 -1.28834620180E-02 -1.27916980692E-02 -1.26912712636E-02 -1.25820686180E-02 -1.24639870989E-02 -1.23369343125E-02 -1.22008292039E-02 -1.20556027669E-02 -1.19011987589E-02 -1.17375744220E-02 -1.15647012072E-02 -1.13825654981E-02 -1.11911693345E-02 -1.09905311305E-02 -1.07806863860E-02 -1.05616883884E-02 -1.03336089005E-02 -1.00965388327E-02 -9.85058889450E-03 -9.59589022348E-03 -9.33259498584E-03 -9.06087694631E-03 -8.78093200236E-03 -8.49297867875E-03 -8.19725857792E-03 -7.89403678182E-03 -7.58360220035E-03 -7.26626786184E-03 -6.94237114075E-03 -6.61227391758E-03 -6.27636266625E-03 -5.93504846392E-03 -5.58876691837E-03 -5.23797800812E-03 -4.88316583033E-03 -4.52483825200E-03 -4.16352645967E-03 -3.79978440342E-03 -3.43418813081E-03 -3.06733500694E-03 -2.69984281695E-03 -2.33234874756E-03 -1.96550824488E-03 -1.59999374583E-03 -1.23649328122E-03 -8.75708948985E-04 -5.18355256627E-04 -1.65157332543E-04 1.83150993353E-04 5.25829238659E-04 8.62132445277E-04 1.19131348132E-03 1.51262546453E-03 1.82532430289E-03 2.12867134686E-03 2.42193614699E-03 2.70439930957E-03 2.97535544170E-03 3.23411617654E-03 3.48001326802E-03 3.71240174343E-03 3.93066310121E-03 4.13420854003E-03 4.32248220447E-03 4.49496443122E-03 4.65117497909E-03 4.79067622483E-03 4.91307630606E-03 5.01803219184E-03 5.10525266026E-03 5.17450116237E-03 5.22559855059E-03 5.25842564974E-03 5.27292564825E-03 5.26910628694E-03 5.24704182276E-03 5.20687474501E-03 5.14881722159E-03 5.07315225356E-03 4.98023451665E-03 4.87049086920E-03 4.74442050701E-03 4.60259474666E-03 4.44565642034E-03 4.27431886631E-03 4.08936450155E-03 3.89164296411E-03 3.68206881556E-03 3.46161879543E-03 3.23132862239E-03 2.99228933896E-03 2.74564319946E-03 2.49257910327E-03 2.23432757852E-03 1.97215532376E-03 1.70735931849E-03 1.44126051571E-03 1.17519713300E-03 9.10517561080E-04 6.48572911762E-04 3.90709229767E-04 1.38259395522E-04 -1.07465251515E-04 -3.45183537122E-04 -5.73653290051E-04 -7.91680357128E-04 -9.98127757652E-04 -1.19192493731E-03 -1.37207708026E-03 -1.53767443642E-03 -1.68790161996E-03 -1.82204683338E-03 -1.93951097071E-03 -2.03981655209E-03 -2.12261644085E-03 -2.18770229328E-03 -2.23501268976E-03 -2.26464089490E-03 -2.27684219249E-03 -2.27204073964E-03 -2.25083588221E-03 -2.21400787126E-03 -2.16252291769E-03 -2.09753751850E-03 -2.02040198483E-03 -1.93266309699E-03 -1.83606580708E-03 -1.73255390364E-03 -1.62426954643E-03 -1.51355157180E-03 -1.40259528100E-03 -1.29237558127E-03 -1.18354615449E-03 -1.07675461706E-03 -9.72635383575E-04 -8.71802294702E-04 -7.74841063435E-04 -6.82301600927E-04 -5.94690290085E-04 -5.12462282349E-04 -4.36013900322E-04 -3.65675236327E-04 -3.01703044258E-04 -2.44274029346E-04 -1.93478647601E-04 -1.49315533530E-04 -1.11686681354E-04 -8.03935110531E-05 -5.51339562810E-05 -3.55007161613E-05 -2.09808173083E-05 -1.09566358007E-05 -4.70853123543E-06 -1.41924622508E-06 -1.80224600575E-07 -6.20342723122E-18 -1.05271154876E-17 -2.16116248865E-20 -4.23800675523E-18 -1.60054362008E-18 -1.43472843546E-17 -3.72514475849E-18 5.08797939413E-19 -1.50719572466E-18 4.16001117362E-19 1.09020737003E-18 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 3 3 1 i j (l(j)) 7.34019364407E-02 Q_int 7.71553715502E-12 7.96642648114E-12 8.22547406812E-12 8.49294520057E-12 8.76911378941E-12 9.05426265238E-12 9.34868380366E-12 9.65267875288E-12 9.96655881395E-12 1.02906454238E-11 1.06252704716E-11 1.09707766386E-11 1.13275177490E-11 1.16958591325E-11 1.20761779982E-11 1.24688638208E-11 1.28743187400E-11 1.32929579715E-11 1.37252102329E-11 1.41715181823E-11 1.46323388718E-11 1.51081442155E-11 1.55994214729E-11 1.61066737475E-11 1.66304205026E-11 1.71711980925E-11 1.77295603126E-11 1.83060789658E-11 1.89013444485E-11 1.95159663549E-11 2.01505741015E-11 2.08058175716E-11 2.14823677806E-11 2.21809175634E-11 2.29021822839E-11 2.36469005674E-11 2.44158350571E-11 2.52097731949E-11 2.60295280282E-11 2.68759390420E-11 2.77498730189E-11 2.86522249266E-11 2.95839188344E-11 3.05459088595E-11 3.15391801441E-11 3.25647498640E-11 3.36236682706E-11 3.47170197661E-11 3.58459240141E-11 3.70115370861E-11 3.82150526456E-11 3.94577031700E-11 4.07407612131E-11 4.20655407081E-11 4.34333983132E-11 4.48457348007E-11 4.63039964915E-11 4.78096767361E-11 4.93643174443E-11 5.09695106633E-11 5.26269002089E-11 5.43381833483E-11 5.61051125381E-11 5.79294972192E-11 5.98132056694E-11 6.17581669169E-11 6.37663727153E-11 6.58398795833E-11 6.79808109108E-11 7.01913591331E-11 7.24737879762E-11 7.48304347747E-11 7.72637128651E-11 7.97761140578E-11 8.23702111877E-11 8.50486607499E-11 8.78142056191E-11 9.06696778590E-11 9.36180016219E-11 9.66621961432E-11 9.98053788332E-11 1.03050768469E-10 1.06401688492E-10 1.09861570408E-10 1.13433957304E-10 1.17122507476E-10 1.20930998173E-10 1.24863329468E-10 1.28923528248E-10 1.33115752341E-10 1.37444294772E-10 1.41913588158E-10 1.46528209249E-10 1.51292883612E-10 1.56212490475E-10 1.61292067715E-10 1.66536817025E-10 1.71952109237E-10 1.77543489818E-10 1.83316684555E-10 1.89277605415E-10 1.95432356596E-10 2.01787240785E-10 2.08348765601E-10 2.15123650271E-10 2.22118832498E-10 2.29341475574E-10 2.36798975712E-10 2.44498969618E-10 2.52449342313E-10 2.60658235204E-10 2.69134054425E-10 2.77885479439E-10 2.86921471929E-10 2.96251284975E-10 3.05884472525E-10 3.15830899180E-10 3.26100750295E-10 3.36704542407E-10 3.47653134007E-10 3.58957736650E-10 3.70629926445E-10 3.82681655901E-10 3.95125266168E-10 4.07973499673E-10 4.21239513169E-10 4.34936891204E-10 4.49079660031E-10 4.63682301970E-10 4.78759770238E-10 4.94327504256E-10 5.10401445461E-10 5.26998053629E-10 5.44134323723E-10 5.61827803301E-10 5.80096610478E-10 5.98959452477E-10 6.18435644786E-10 6.38545130933E-10 6.59308502905E-10 6.80747022234E-10 7.02882641763E-10 7.25738028127E-10 7.49336584956E-10 7.73702476840E-10 7.98860654070E-10 8.24836878182E-10 8.51657748334E-10 8.79350728540E-10 9.07944175789E-10 9.37467369075E-10 9.67950539378E-10 9.99424900612E-10 1.03192268159E-09 1.06547715900E-09 1.10012269151E-09 1.13589475491E-09 1.17282997845E-09 1.21096618234E-09 1.25034241646E-09 1.29099900036E-09 1.33297756452E-09 1.37632109298E-09 1.42107396733E-09 1.46728201219E-09 1.51499254205E-09 1.56425440980E-09 1.61511805667E-09 1.66763556391E-09 1.72186070607E-09 1.77784900610E-09 1.83565779217E-09 1.89534625635E-09 1.95697551520E-09 2.02060867236E-09 2.08631088316E-09 2.15414942127E-09 2.22419374761E-09 2.29651558145E-09 2.37118897383E-09 2.44829038333E-09 2.52789875441E-09 2.61009559816E-09 2.69496507576E-09 2.78259408465E-09 2.87307234745E-09 2.96649250384E-09 3.06295020536E-09 3.16254421335E-09 3.26537650000E-09 3.37155235278E-09 3.48118048221E-09 3.59437313308E-09 3.71124619941E-09 3.83191934305E-09 3.95651611614E-09 4.08516408763E-09 4.21799497381E-09 4.35514477312E-09 4.49675390541E-09 4.64296735561E-09 4.79393482213E-09 4.94981087011E-09 5.11075508961E-09 5.27693225891E-09 5.44851251321E-09 5.62567151875E-09 5.80859065258E-09 5.99745718821E-09 6.19246448725E-09 6.39381219735E-09 6.60170645647E-09 6.81636010391E-09 7.03799289805E-09 7.26683174134E-09 7.50311091244E-09 7.74707230602E-09 7.99896568025E-09 8.25904891248E-09 8.52758826304E-09 8.80485864778E-09 9.09114391938E-09 9.38673715778E-09 9.69194097015E-09 1.00070678005E-08 1.03324402494E-08 1.06683914040E-08 1.10152651791E-08 1.13734166688E-08 1.17432125100E-08 1.21250312574E-08 1.25192637708E-08 1.29263136154E-08 1.33465974741E-08 1.37805455746E-08 1.42286021286E-08 1.46912257871E-08 1.51688901094E-08 1.56620840474E-08 1.61713124460E-08 1.66970965596E-08 1.72399745852E-08 1.78005022131E-08 1.83792531953E-08 1.89768199328E-08 1.95938140808E-08 2.02308671751E-08 2.08886312780E-08 2.15677796450E-08 2.22690074136E-08 2.29930323144E-08 2.37405954054E-08 2.45124618294E-08 2.53094215971E-08 2.61322903951E-08 2.69819104199E-08 2.78591512392E-08 2.87649106815E-08 2.97001157543E-08 3.06657235918E-08 3.16627224341E-08 3.26921326375E-08 3.37550077180E-08 3.48524354287E-08 3.59855388721E-08 3.71554776483E-08 3.83634490409E-08 3.96106892412E-08 4.08984746119E-08 4.22281229924E-08 4.36009950459E-08 4.50184956508E-08 4.64820753367E-08 4.79932317673E-08 4.95535112717E-08 5.11645104250E-08 5.28278776802E-08 5.45453150534E-08 5.63185798639E-08 5.81494865296E-08 6.00399084224E-08 6.19917797824E-08 6.40070976947E-08 6.60879241310E-08 6.82363880564E-08 7.04546876052E-08 7.27450923271E-08 7.51099455068E-08 7.75516665579E-08 8.00727534953E-08 8.26757854878E-08 8.53634254929E-08 8.81384229778E-08 9.10036167283E-08 9.39619377490E-08 9.70164122572E-08 1.00170164775E-07 1.03426421319E-07 1.06788512700E-07 1.10259877920E-07 1.13844067685E-07 1.17544748038E-07 1.21365704093E-07 1.25310843909E-07 1.29384202476E-07 1.33589945838E-07 1.37932375344E-07 1.42415932043E-07 1.47045201215E-07 1.51824917054E-07 1.56759967504E-07 1.61855399243E-07 1.67116422837E-07 1.72548418062E-07 1.78156939389E-07 1.83947721658E-07 1.89926685926E-07 1.96099945516E-07 2.02473812249E-07 2.09054802888E-07 2.15849645786E-07 2.22865287751E-07 2.30108901134E-07 2.37587891145E-07 2.45309903406E-07 2.53282831752E-07 2.61514826281E-07 2.70014301665E-07 2.78789945733E-07 2.87850728332E-07 2.97205910470E-07 3.06865053759E-07 3.16838030167E-07 3.27135032077E-07 3.37766582681E-07 3.48743546704E-07 3.60077141481E-07 3.71778948383E-07 3.83860924627E-07 3.96335415453E-07 4.09215166710E-07 4.22513337835E-07 4.36243515264E-07 4.50419726269E-07 4.65056453248E-07 4.80168648474E-07 4.95771749321E-07 5.11881693986E-07 5.28514937717E-07 5.45688469565E-07 5.63419829680E-07 5.81727127167E-07 6.00629058514E-07 6.20144926623E-07 6.40294660450E-07 6.61098835287E-07 6.82578693693E-07 7.04756167101E-07 7.27653898132E-07 7.51295263621E-07 7.75704398390E-07 8.00906219790E-07 8.26926453037E-07 8.53791657362E-07 8.81529253008E-07 9.10167549102E-07 9.39735772419E-07 9.70264097087E-07 1.00178367524E-06 1.03432666865E-06 1.06792628142E-06 1.10261679370E-06 1.13843359648E-06 1.17541322753E-06 1.21359340850E-06 1.25301308321E-06 1.29371245715E-06 1.33573303830E-06 1.37911767926E-06 1.42391062068E-06 1.47015753613E-06 1.51790557847E-06 1.56720342763E-06 1.61810133993E-06 1.67065119908E-06 1.72490656872E-06 1.78092274670E-06 1.83875682113E-06 1.89846772817E-06 1.96011631174E-06 2.02376538511E-06 2.08947979452E-06 2.15732648478E-06 2.22737456707E-06 2.29969538878E-06 2.37436260579E-06 2.45145225689E-06 2.53104284068E-06 2.61321539499E-06 2.69805357870E-06 2.78564375635E-06 2.87607508538E-06 2.96943960617E-06 3.06583233502E-06 3.16535136008E-06 3.26809794033E-06 3.37417660780E-06 3.48369527306E-06 3.59676533401E-06 3.71350178828E-06 3.83402334911E-06 3.95845256509E-06 4.08691594356E-06 4.21954407813E-06 4.35647178015E-06 4.49783821451E-06 4.64378703967E-06 4.79446655224E-06 4.95002983621E-06 5.11063491686E-06 5.27644491967E-06 5.44762823429E-06 5.62435868373E-06 5.80681569898E-06 5.99518449921E-06 6.18965627767E-06 6.39042839359E-06 6.59770457019E-06 6.81169509898E-06 7.03261705055E-06 7.26069449220E-06 7.49615871235E-06 7.73924845220E-06 7.99021014474E-06 8.24929816136E-06 8.51677506633E-06 8.79291187936E-06 9.07798834648E-06 9.37229321961E-06 9.67612454493E-06 9.98978996048E-06 1.03136070031E-05 1.06479034254E-05 1.09930175222E-05 1.13492984680E-05 1.17171066649E-05 1.20968141012E-05 1.24888047218E-05 1.28934748102E-05 1.33112333827E-05 1.37425025944E-05 1.41877181593E-05 1.46473297825E-05 1.51218016064E-05 1.56116126716E-05 1.61172573910E-05 1.66392460407E-05 1.71781052645E-05 1.77343785956E-05 1.83086269940E-05 1.89014294015E-05 1.95133833133E-05 2.01451053683E-05 2.07972319576E-05 2.14704198519E-05 2.21653468496E-05 2.28827124435E-05 2.36232385102E-05 2.43876700200E-05 2.51767757692E-05 2.59913491354E-05 2.68322088567E-05 2.77001998349E-05 2.85961939636E-05 2.95210909827E-05 3.04758193589E-05 3.14613371944E-05 3.24786331633E-05 3.35287274770E-05 3.46126728803E-05 3.57315556778E-05 3.68864967926E-05 3.80786528574E-05 3.93092173400E-05 4.05794217028E-05 4.18905365992E-05 4.32438731061E-05 4.46407839948E-05 4.60826650414E-05 4.75709563773E-05 4.91071438809E-05 5.06927606129E-05 5.23293882955E-05 5.40186588365E-05 5.57622559007E-05 5.75619165294E-05 5.94194328093E-05 6.13366535925E-05 6.33154862692E-05 6.53578985942E-05 6.74659205695E-05 6.96416463838E-05 7.18872364109E-05 7.42049192698E-05 7.65969939459E-05 7.90658319773E-05 8.16138797075E-05 8.42436606052E-05 8.69577776553E-05 8.97589158211E-05 9.26498445811E-05 9.56334205419E-05 9.87125901293E-05 1.01890392361E-04 1.05169961701E-04 1.08554531000E-04 1.12047434524E-04 1.15652111072E-04 1.19372107189E-04 1.23211080469E-04 1.27172802962E-04 1.31261164682E-04 1.35480177208E-04 1.39833977407E-04 1.44326831258E-04 1.48963137784E-04 1.53747433111E-04 1.58684394635E-04 1.63778845317E-04 1.69035758103E-04 1.74460260470E-04 1.80057639103E-04 1.85833344715E-04 1.91792996997E-04 1.97942389716E-04 2.04287495961E-04 2.10834473535E-04 2.17589670505E-04 2.24559630912E-04 2.31751100639E-04 2.39171033448E-04 2.46826597193E-04 2.54725180200E-04 2.62874397835E-04 2.71282099253E-04 2.79956374334E-04 2.88905560823E-04 2.98138251654E-04 3.07663302492E-04 3.17489839476E-04 3.27627267178E-04 3.38085276782E-04 3.48873854487E-04 3.60003290139E-04 3.71484186101E-04 3.83327466359E-04 3.95544385882E-04 4.08146540228E-04 4.21145875409E-04 4.34554698024E-04 4.48385685654E-04 4.62651897545E-04 4.77366785560E-04 4.92544205428E-04 5.08198428283E-04 5.24344152507E-04 5.40996515876E-04 5.58171108027E-04 5.75883983231E-04 5.94151673511E-04 6.12991202077E-04 6.32420097107E-04 6.52456405876E-04 6.73118709238E-04 6.94426136458E-04 7.16398380422E-04 7.39055713216E-04 7.62419002078E-04 7.86509725745E-04 8.11349991185E-04 8.36962550732E-04 8.63370819627E-04 8.90598893965E-04 9.18671569065E-04 9.47614358264E-04 9.77453512138E-04 1.00821603816E-03 1.03992972080E-03 1.07262314208E-03 1.10632570255E-03 1.14106764279E-03 1.17688006528E-03 1.21379495683E-03 1.25184521142E-03 1.29106465352E-03 1.33148806196E-03 1.37315119415E-03 1.41609081095E-03 1.46034470187E-03 1.50595171089E-03 1.55295176266E-03 1.60138588933E-03 1.65129625770E-03 1.70272619702E-03 1.75572022722E-03 1.81032408758E-03 1.86658476601E-03 1.92455052868E-03 1.98427095026E-03 2.04579694453E-03 2.10918079554E-03 2.17447618917E-03 2.24173824522E-03 2.31102354988E-03 2.38239018867E-03 2.45589777981E-03 2.53160750800E-03 2.60958215857E-03 2.68988615208E-03 2.77258557919E-03 2.85774823598E-03 2.94544365954E-03 3.03574316384E-03 3.12871987594E-03 3.22444877241E-03 3.32300671600E-03 3.42447249246E-03 3.52892684759E-03 3.63645252431E-03 3.74713429995E-03 3.86105902344E-03 3.97831565261E-03 4.09899529140E-03 4.22319122694E-03 4.35099896656E-03 4.48251627451E-03 4.61784320848E-03 4.75708215570E-03 4.90033786879E-03 5.04771750096E-03 5.19933064081E-03 5.35528934643E-03 5.51570817881E-03 5.68070423443E-03 5.85039717704E-03 6.02490926829E-03 6.20436539747E-03 6.38889310983E-03 6.57862263380E-03 6.77368690657E-03 6.97422159827E-03 7.18036513434E-03 7.39225871611E-03 7.61004633945E-03 7.83387481119E-03 8.06389376333E-03 8.30025566476E-03 8.54311583040E-03 8.79263242746E-03 9.04896647881E-03 9.31228186307E-03 9.58274531139E-03 9.86052640059E-03 1.01457975425E-02 1.04387339692E-02 1.07395137142E-02 1.10483175887E-02 1.13653291536E-02 1.16907346859E-02 1.20247231405E-02 1.23674861055E-02 1.27192177525E-02 1.30801147804E-02 1.34503763525E-02 1.38302040271E-02 1.42198016810E-02 1.46193754254E-02 1.50291335140E-02 1.54492862432E-02 1.58800458435E-02 1.63216263625E-02 1.67742435376E-02 1.72381146607E-02 1.77134584314E-02 1.82004948007E-02 1.86994448031E-02 1.92105303785E-02 1.97339741814E-02 2.02699993785E-02 2.08188294342E-02 2.13806878818E-02 2.19557980833E-02 2.25443829731E-02 2.31466647898E-02 2.37628647909E-02 2.43932029547E-02 2.50378976643E-02 2.56971653775E-02 2.63712202792E-02 2.70602739166E-02 2.77645348184E-02 2.84842080950E-02 2.92194950206E-02 2.99705925980E-02 3.07376931030E-02 3.15209836102E-02 3.23206454995E-02 3.31368539418E-02 3.39697773655E-02 3.48195769015E-02 3.56864058082E-02 3.65704088751E-02 3.74717218054E-02 3.83904705776E-02 3.93267707852E-02 4.02807269555E-02 4.12524318467E-02 4.22419657237E-02 4.32493956128E-02 4.42747745351E-02 4.53181407194E-02 4.63795167941E-02 4.74589089593E-02 4.85563061393E-02 4.96716791156E-02 5.08049796420E-02 5.19561395409E-02 5.31250697838E-02 5.43116595552E-02 5.55157753014E-02 5.67372597659E-02 5.79759310118E-02 5.92315814334E-02 6.05039767582E-02 6.17928550406E-02 6.30979256498E-02 6.44188682532E-02 6.57553317983E-02 6.71069334938E-02 6.84732577946E-02 6.98538553904E-02 7.12482422039E-02 7.26558983987E-02 7.40762674015E-02 7.55087549416E-02 7.69527281116E-02 7.84075144511E-02 7.98724010606E-02 8.13466337458E-02 8.28294161993E-02 8.43199092232E-02 8.58172299965E-02 8.73204513933E-02 8.88286013561E-02 9.03406623287E-02 9.18555707553E-02 9.33722166505E-02 9.48894432456E-02 9.64060467174E-02 9.79207760051E-02 9.94323327220E-02 1.00939371167E-01 1.02440498441E-01 1.03934274682E-01 1.05419213410E-01 1.06893782008E-01 1.08356402327E-01 1.09805451430E-01 1.11239262489E-01 1.12656125821E-01 1.14054290091E-01 1.15431963672E-01 1.16787316179E-01 1.18118480174E-01 1.19423553055E-01 1.20700599125E-01 1.21947651863E-01 1.23162716372E-01 1.24343772048E-01 1.25488775432E-01 1.26595663281E-01 1.27662355843E-01 1.28686760343E-01 1.29666774680E-01 1.30600291342E-01 1.31485201525E-01 1.32319399472E-01 1.33100787014E-01 1.33827278328E-01 1.34496804888E-01 1.35107320621E-01 1.35656807256E-01 1.36143279851E-01 1.36564792511E-01 1.36919444260E-01 1.37205385080E-01 1.37420822094E-01 1.37564025875E-01 1.37633336882E-01 1.37627171989E-01 1.37544031104E-01 1.37382503848E-01 1.37141276282E-01 1.36819137655E-01 1.36414987152E-01 1.35927840618E-01 1.35356837228E-01 1.34701246084E-01 1.33960472695E-01 1.33134065335E-01 1.32221721220E-01 1.31223292491E-01 1.30138791965E-01 1.28968398618E-01 1.27712462766E-01 1.26371510911E-01 1.24946250212E-01 1.23437572555E-01 1.21846558167E-01 1.20174478759E-01 1.18422800147E-01 1.16593184323E-01 1.14687490935E-01 1.12707778150E-01 1.10656302854E-01 1.08535520176E-01 1.06348082283E-01 1.04096836435E-01 1.01784822266E-01 9.94152682684E-02 9.69915874528E-02 9.45173721755E-02 9.19963881072E-02 8.94325673357E-02 8.68300005897E-02 8.41929285814E-02 8.15257324629E-02 7.88329234014E-02 7.61191312788E-02 7.33890925265E-02 7.06476371138E-02 6.78996747075E-02 6.51501800327E-02 6.24041774618E-02 5.96667248713E-02 5.69428968060E-02 5.42377669974E-02 5.15563902890E-02 4.89037840244E-02 4.62849089606E-02 4.37046497729E-02 4.11677952234E-02 3.86790180671E-02 3.62428547770E-02 3.38636851705E-02 3.15457120227E-02 2.92929407582E-02 2.71091593091E-02 2.49979182353E-02 2.29625111975E-02 2.10059558788E-02 1.91309754456E-02 1.73399806399E-02 1.56350525899E-02 1.40179264246E-02 1.24899757695E-02 1.10521982004E-02 9.70520171739E-03 8.44919230045E-03 7.28396259285E-03 6.20888175078E-03 5.22288648477E-03 4.32447330540E-03 3.51169197199E-03 2.78214012792E-03 2.13295909050E-03 1.56083074720E-03 1.06197549337E-03 6.32151130184E-04 2.66652625158E-04 -3.96873776867E-05 -2.92497425388E-04 -4.97865641141E-04 -6.61672748288E-04 -7.87483460656E-04 -8.78337171466E-04 -9.37366962468E-04 -9.67779066612E-04 -9.72830694544E-04 -9.55806232713E-04 -9.19991827585E-04 -8.68648377335E-04 -8.04982959518E-04 -7.32118730621E-04 -6.53063341282E-04 -5.70675919141E-04 -4.87632680120E-04 -4.06391238465E-04 -3.29153696248E-04 -2.57828604528E-04 -1.93991901127E-04 -1.38846944340E-04 -9.31837780915E-05 -5.73377825392E-05 -3.11478850484E-05 -1.39145304726E-05 -4.35763696657E-06 -5.74794676535E-07 -5.59759346703E-18 -1.70678771440E-17 -1.46011082910E-17 -1.08654933819E-17 -9.06757161320E-18 -3.38525240731E-18 1.43962287232E-17 -6.16296218324E-18 1.79493617794E-17 1.91168204265E-17 1.82460600274E-18 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 3 4 1 i j (l(j)) 6.17771520252E-02 Q_int 6.60100186901E-12 6.81564938209E-12 7.03727666730E-12 7.26611068798E-12 7.50238578765E-12 7.74634393004E-12 7.99823494686E-12 8.25831679364E-12 8.52685581389E-12 8.80412701186E-12 9.09041433415E-12 9.38601096050E-12 9.69121960402E-12 1.00063528212E-11 1.03317333319E-11 1.06676943500E-11 1.10145799246E-11 1.13727452920E-11 1.17425572400E-11 1.21243944833E-11 1.25186480511E-11 1.29257216879E-11 1.33460322669E-11 1.37800102164E-11 1.42280999613E-11 1.46907603779E-11 1.51684652637E-11 1.56617038226E-11 1.61709811662E-11 1.66968188307E-11 1.72397553110E-11 1.78003466125E-11 1.83791668200E-11 1.89768086860E-11 1.95938842375E-11 2.02310254026E-11 2.08888846580E-11 2.15681356969E-11 2.22694741189E-11 2.29936181424E-11 2.37413093402E-11 2.45133133986E-11 2.53104209018E-11 2.61334481413E-11 2.69832379517E-11 2.78606605744E-11 2.87666145479E-11 2.97020276287E-11 3.06678577408E-11 3.16650939570E-11 3.26947575116E-11 3.37579028463E-11 3.48556186897E-11 3.59890291725E-11 3.71592949786E-11 3.83676145335E-11 3.96152252319E-11 4.09034047041E-11 4.22334721253E-11 4.36067895656E-11 4.50247633855E-11 4.64888456755E-11 4.80005357434E-11 4.95613816496E-11 5.11729817920E-11 5.28369865434E-11 5.45550999412E-11 5.63290814321E-11 5.81607476743E-11 6.00519743976E-11 6.20046983241E-11 6.40209191514E-11 6.61027016005E-11 6.82521775300E-11 7.04715481192E-11 7.27630861221E-11 7.51291381947E-11 7.75721272980E-11 8.00945551792E-11 8.26990049335E-11 8.53881436491E-11 8.81647251385E-11 9.10315927581E-11 9.39916823201E-11 9.70480250988E-11 1.00203750934E-10 1.03462091438E-10 1.06826383300E-10 1.10300071710E-10 1.13886713879E-10 1.17589982689E-10 1.21413670446E-10 1.25361692772E-10 1.29438092606E-10 1.33647044351E-10 1.37992858144E-10 1.42479984272E-10 1.47113017726E-10 1.51896702911E-10 1.56835938499E-10 1.61935782449E-10 1.67201457183E-10 1.72638354938E-10 1.78252043282E-10 1.84048270818E-10 1.90032973074E-10 1.96212278571E-10 2.02592515109E-10 2.09180216240E-10 2.15982127959E-10 2.23005215614E-10 2.30256671036E-10 2.37743919902E-10 2.45474629343E-10 2.53456715790E-10 2.61698353083E-10 2.70207980838E-10 2.78994313091E-10 2.88066347221E-10 2.97433373160E-10 3.07104982906E-10 3.17091080346E-10 3.27401891398E-10 3.38047974477E-10 3.49040231310E-10 3.60389918097E-10 3.72108657036E-10 3.84208448225E-10 3.96701681948E-10 4.09601151358E-10 4.22920065584E-10 4.36672063249E-10 4.50871226435E-10 4.65532095106E-10 4.80669681992E-10 4.96299487960E-10 5.12437517889E-10 5.29100297050E-10 5.46304888036E-10 5.64068908220E-10 5.82410547805E-10 6.01348588440E-10 6.20902422452E-10 6.41092072704E-10 6.61938213091E-10 6.83462189712E-10 7.05686042720E-10 7.28632528892E-10 7.52325144928E-10 7.76788151506E-10 8.02046598120E-10 8.28126348731E-10 8.55054108243E-10 8.82857449848E-10 9.11564843250E-10 9.41205683820E-10 9.71810322687E-10 1.00341009781E-09 1.03603736607E-09 1.06972553639E-09 1.10450910393E-09 1.14042368543E-09 1.17750605565E-09 1.21579418502E-09 1.25532727852E-09 1.29614581583E-09 1.33829159274E-09 1.38180776398E-09 1.42673888734E-09 1.47313096936E-09 1.52103151238E-09 1.57048956316E-09 1.62155576314E-09 1.67428240024E-09 1.72872346242E-09 1.78493469290E-09 1.84297364729E-09 1.90289975245E-09 1.96477436738E-09 2.02866084597E-09 2.09462460191E-09 2.16273317563E-09 2.23305630343E-09 2.30566598889E-09 2.38063657654E-09 2.45804482802E-09 2.53797000058E-09 2.62049392830E-09 2.70570110577E-09 2.79367877465E-09 2.88451701293E-09 2.97830882713E-09 3.07515024756E-09 3.17514042654E-09 3.27838173994E-09 3.38497989195E-09 3.49504402327E-09 3.60868682284E-09 3.72602464319E-09 3.84717761948E-09 3.97226979253E-09 4.10142923572E-09 4.23478818611E-09 4.37248317979E-09 4.51465519158E-09 4.66144977937E-09 4.81301723306E-09 4.96951272839E-09 5.13109648574E-09 5.29793393414E-09 5.47019588053E-09 5.64805868462E-09 5.83170443932E-09 6.02132115714E-09 6.21710296260E-09 6.41925029085E-09 6.62797009284E-09 6.84347604709E-09 7.06598877831E-09 7.29573608327E-09 7.53295316379E-09 7.77788286754E-09 8.03077593645E-09 8.29189126336E-09 8.56149615690E-09 8.83986661501E-09 9.12728760739E-09 9.42405336705E-09 9.73046769140E-09 1.00468442531E-08 1.03735069209E-08 1.07107900913E-08 1.10590390304E-08 1.14186102271E-08 1.17898717582E-08 1.21732036647E-08 1.25689983408E-08 1.29776609350E-08 1.33996097651E-08 1.38352767456E-08 1.42851078302E-08 1.47495634675E-08 1.52291190723E-08 1.57242655116E-08 1.62355096073E-08 1.67633746542E-08 1.73084009555E-08 1.78711463753E-08 1.84521869096E-08 1.90521172749E-08 1.96715515170E-08 2.03111236389E-08 2.09714882492E-08 2.16533212317E-08 2.23573204367E-08 2.30842063945E-08 2.38347230527E-08 2.46096385367E-08 2.54097459352E-08 2.62358641118E-08 2.70888385418E-08 2.79695421768E-08 2.88788763380E-08 2.98177716372E-08 3.07871889287E-08 3.17881202915E-08 3.28215900442E-08 3.38886557918E-08 3.49904095075E-08 3.61279786485E-08 3.73025273096E-08 3.85152574124E-08 3.97674099347E-08 4.10602661789E-08 4.23951490816E-08 4.37734245666E-08 4.51965029406E-08 4.66658403348E-08 4.81829401937E-08 4.97493548114E-08 5.13666869185E-08 5.30365913197E-08 5.47607765856E-08 5.65410067985E-08 5.83791033553E-08 6.02769468289E-08 6.22364788896E-08 6.42597042897E-08 6.63486929115E-08 6.85055818828E-08 7.07325777599E-08 7.30319587824E-08 7.54060772005E-08 7.78573616787E-08 8.03883197762E-08 8.30015405089E-08 8.56996969939E-08 8.84855491801E-08 9.13619466671E-08 9.43318316161E-08 9.73982417541E-08 1.00564313477E-07 1.03833285053E-07 1.07208499927E-07 1.10693410139E-07 1.14291579845E-07 1.18006688957E-07 1.21842536904E-07 1.25803046506E-07 1.29892267980E-07 1.34114383077E-07 1.38473709350E-07 1.42974704558E-07 1.47621971221E-07 1.52420261313E-07 1.57374481114E-07 1.62489696218E-07 1.67771136700E-07 1.73224202454E-07 1.78854468702E-07 1.84667691684E-07 1.90669814530E-07 1.96866973320E-07 2.03265503350E-07 2.09871945587E-07 2.16693053345E-07 2.23735799173E-07 2.31007381964E-07 2.38515234295E-07 2.46267030011E-07 2.54270692044E-07 2.62534400494E-07 2.71066600968E-07 2.79876013190E-07 2.88971639888E-07 2.98362775971E-07 3.08059018002E-07 3.18070273977E-07 3.28406773425E-07 3.39079077826E-07 3.50098091376E-07 3.61475072095E-07 3.73221643293E-07 3.85349805411E-07 3.97871948247E-07 4.10800863568E-07 4.24149758139E-07 4.37932267174E-07 4.52162468213E-07 4.66854895455E-07 4.82024554557E-07 4.97686937904E-07 5.13858040376E-07 5.30554375627E-07 5.47792992888E-07 5.65591494312E-07 5.83968052885E-07 6.02941430907E-07 6.22530999079E-07 6.42756756203E-07 6.63639349514E-07 6.85200095680E-07 7.07461002470E-07 7.30444791125E-07 7.54174919453E-07 7.78675605671E-07 8.03971853009E-07 8.30089475120E-07 8.57055122302E-07 8.84896308567E-07 9.13641439587E-07 9.43319841538E-07 9.73961790880E-07 1.00559854509E-06 1.03826237440E-06 1.07198659452E-06 1.10680560050E-06 1.14275490157E-06 1.17987115721E-06 1.21819221429E-06 1.25775714550E-06 1.29860628894E-06 1.34078128902E-06 1.38432513867E-06 1.42928222294E-06 1.47569836395E-06 1.52362086732E-06 1.57309857010E-06 1.62418189022E-06 1.67692287755E-06 1.73137526662E-06 1.78759453095E-06 1.84563793928E-06 1.90556461344E-06 1.96743558820E-06 2.03131387302E-06 2.09726451573E-06 2.16535466831E-06 2.23565365479E-06 2.30823304129E-06 2.38316670835E-06 2.46053092553E-06 2.54040442850E-06 2.62286849847E-06 2.70800704429E-06 2.79590668715E-06 2.88665684793E-06 2.98034983745E-06 3.07708094958E-06 3.17694855727E-06 3.28005421178E-06 3.38650274495E-06 3.49640237488E-06 3.60986481493E-06 3.72700538617E-06 3.84794313349E-06 3.97280094544E-06 4.10170567783E-06 4.23478828137E-06 4.37218393329E-06 4.51403217330E-06 4.66047704375E-06 4.81166723439E-06 4.96775623166E-06 5.12890247284E-06 5.29526950503E-06 5.46702614924E-06 5.64434666978E-06 5.82741094890E-06 6.01640466716E-06 6.21151948945E-06 6.41295325697E-06 6.62091018530E-06 6.83560106883E-06 7.05724349164E-06 7.28606204509E-06 7.52228855239E-06 7.76616230027E-06 8.01793027797E-06 8.27784742391E-06 8.54617688014E-06 8.82319025485E-06 9.10916789328E-06 9.40439915716E-06 9.70918271301E-06 1.00238268296E-05 1.03486496849E-05 1.06839796826E-05 1.10301557787E-05 1.13875278186E-05 1.17564568845E-05 1.21373156542E-05 1.25304887708E-05 1.29363732247E-05 1.33553787466E-05 1.37879282143E-05 1.42344580708E-05 1.46954187572E-05 1.51712751577E-05 1.56625070594E-05 1.61696096268E-05 1.66930938908E-05 1.72334872527E-05 1.77913340050E-05 1.83671958677E-05 1.89616525421E-05 1.95753022812E-05 2.02087624786E-05 2.08626702757E-05 2.15376831875E-05 2.22344797487E-05 2.29537601794E-05 2.36962470718E-05 2.44626860981E-05 2.52538467410E-05 2.60705230465E-05 2.69135344003E-05 2.77837263285E-05 2.86819713227E-05 2.96091696914E-05 3.05662504375E-05 3.15541721628E-05 3.25739240010E-05 3.36265265796E-05 3.47130330106E-05 3.58345299135E-05 3.69921384683E-05 3.81870155019E-05 3.94203546079E-05 4.06933873006E-05 4.20073842047E-05 4.33636562818E-05 4.47635560942E-05 4.62084791076E-05 4.76998650339E-05 4.92391992150E-05 5.08280140488E-05 5.24678904591E-05 5.41604594103E-05 5.59074034678E-05 5.77104584069E-05 5.95714148696E-05 6.14921200723E-05 6.34744795655E-05 6.55204590466E-05 6.76320862273E-05 6.98114527581E-05 7.20607162103E-05 7.43821021184E-05 7.67779060834E-05 7.92504959399E-05 8.18023139879E-05 8.44358792918E-05 8.71537900479E-05 8.99587260234E-05 9.28534510674E-05 9.58408156972E-05 9.89237597619E-05 1.02105315184E-04 1.05388608785E-04 1.08776865189E-04 1.12273409822E-04 1.15881671986E-04 1.19605188041E-04 1.23447604660E-04 1.27412682201E-04 1.31504298159E-04 1.35726450735E-04 1.40083262494E-04 1.44578984143E-04 1.49217998408E-04 1.54004824034E-04 1.58944119890E-04 1.64040689201E-04 1.69299483895E-04 1.74725609085E-04 1.80324327665E-04 1.86101065053E-04 1.92061414057E-04 1.98211139888E-04 2.04556185311E-04 2.11102675941E-04 2.17856925693E-04 2.24825442382E-04 2.32014933481E-04 2.39432312041E-04 2.47084702776E-04 2.54979448319E-04 2.63124115647E-04 2.71526502687E-04 2.80194645107E-04 2.89136823290E-04 2.98361569495E-04 3.07877675227E-04 3.17694198788E-04 3.27820473055E-04 3.38266113445E-04 3.49041026115E-04 3.60155416366E-04 3.71619797281E-04 3.83444998587E-04 3.95642175757E-04 4.08222819342E-04 4.21198764561E-04 4.34582201129E-04 4.48385683348E-04 4.62622140456E-04 4.77304887243E-04 4.92447634937E-04 5.08064502370E-04 5.24170027424E-04 5.40779178765E-04 5.57907367874E-04 5.75570461371E-04 5.93784793651E-04 6.12567179828E-04 6.31934928986E-04 6.51905857770E-04 6.72498304281E-04 6.93731142326E-04 7.15623795986E-04 7.38196254540E-04 7.61469087732E-04 7.85463461394E-04 8.10201153422E-04 8.35704570125E-04 8.61996762931E-04 8.89101445477E-04 9.17043011070E-04 9.45846550533E-04 9.75537870434E-04 1.00614351171E-03 1.03769076868E-03 1.07020770847E-03 1.10372319080E-03 1.13826688823E-03 1.17386930678E-03 1.21056180695E-03 1.24837662517E-03 1.28734689566E-03 1.32750667269E-03 1.36889095327E-03 1.41153570025E-03 1.45547786583E-03 1.50075541545E-03 1.54740735218E-03 1.59547374140E-03 1.64499573600E-03 1.69601560188E-03 1.74857674394E-03 1.80272373237E-03 1.85850232942E-03 1.91595951645E-03 1.97514352143E-03 2.03610384678E-03 2.09889129753E-03 2.16355800982E-03 2.23015747980E-03 2.29874459274E-03 2.36937565251E-03 2.44210841130E-03 2.51700209962E-03 2.59411745654E-03 2.67351676014E-03 2.75526385815E-03 2.83942419879E-03 2.92606486173E-03 3.01525458918E-03 3.10706381701E-03 3.20156470601E-03 3.29883117309E-03 3.39893892247E-03 3.50196547685E-03 3.60799020837E-03 3.71709436952E-03 3.82936112380E-03 3.94487557609E-03 4.06372480276E-03 4.18599788138E-03 4.31178592000E-03 4.44118208593E-03 4.57428163393E-03 4.71118193383E-03 4.85198249733E-03 4.99678500406E-03 5.14569332676E-03 5.29881355545E-03 5.45625402054E-03 5.61812531482E-03 5.78454031408E-03 5.95561419645E-03 6.13146446018E-03 6.31221093982E-03 6.49797582070E-03 6.68888365147E-03 6.88506135469E-03 7.08663823529E-03 7.29374598664E-03 7.50651869429E-03 7.72509283703E-03 7.94960728519E-03 8.18020329597E-03 8.41702450571E-03 8.66021691876E-03 8.90992889286E-03 9.16631112087E-03 9.42951660851E-03 9.69970064793E-03 9.97702078708E-03 1.02616367943E-02 1.05537106181E-02 1.08534063421E-02 1.11608901345E-02 1.14763301915E-02 1.17998966758E-02 1.21317616483E-02 1.24720989933E-02 1.28210843376E-02 1.31788949618E-02 1.35457097051E-02 1.39217088620E-02 1.43070740707E-02 1.47019881944E-02 1.51066351925E-02 1.55211999842E-02 1.59458683018E-02 1.63808265349E-02 1.68262615649E-02 1.72823605880E-02 1.77493109288E-02 1.82272998420E-02 1.87165143029E-02 1.92171407864E-02 1.97293650331E-02 2.02533718033E-02 2.07893446183E-02 2.13374654880E-02 2.18979146247E-02 2.24708701436E-02 2.30565077482E-02 2.36550004011E-02 2.42665179804E-02 2.48912269198E-02 2.55292898332E-02 2.61808651241E-02 2.68461065774E-02 2.75251629360E-02 2.82181774589E-02 2.89252874640E-02 2.96466238525E-02 3.03823106160E-02 3.11324643264E-02 3.18971936077E-02 3.26765985899E-02 3.34707703454E-02 3.42797903074E-02 3.51037296700E-02 3.59426487712E-02 3.67965964580E-02 3.76656094336E-02 3.85497115882E-02 3.94489133121E-02 4.03632107931E-02 4.12925852965E-02 4.22370024310E-02 4.31964113985E-02 4.41707442301E-02 4.51599150081E-02 4.61638190756E-02 4.71823322340E-02 4.82153099303E-02 4.92625864336E-02 5.03239740045E-02 5.13992620568E-02 5.24882163137E-02 5.35905779602E-02 5.47060627929E-02 5.58343603702E-02 5.69751331634E-02 5.81280157117E-02 5.92926137834E-02 6.04685035455E-02 6.16552307440E-02 6.28523098981E-02 6.40592235111E-02 6.52754213003E-02 6.65003194502E-02 6.77332998912E-02 6.89737096083E-02 7.02208599827E-02 7.14740261699E-02 7.27324465199E-02 7.39953220404E-02 7.52618159115E-02 7.65310530518E-02 7.78021197441E-02 7.90740633229E-02 8.03458919304E-02 8.16165743433E-02 8.28850398788E-02 8.41501783817E-02 8.54108402998E-02 8.66658368518E-02 8.79139402936E-02 8.91538842880E-02 9.03843643829E-02 9.16040386042E-02 9.28115281677E-02 9.40054183159E-02 9.51842592843E-02 9.63465674037E-02 9.74908263409E-02 9.86154884860E-02 9.97189764871E-02 1.00799684940E-01 1.01855982238E-01 1.02886212574E-01 1.03888698125E-01 1.04861741385E-01 1.05803627686E-01 1.06712627880E-01 1.07587001204E-01 1.08424998319E-01 1.09224864522E-01 1.09984843141E-01 1.10703179106E-01 1.11378122685E-01 1.12007933410E-01 1.12590884154E-01 1.13125265387E-01 1.13609389588E-01 1.14041595815E-01 1.14420254417E-01 1.14743771895E-01 1.15010595890E-01 1.15219220297E-01 1.15368190485E-01 1.15456108621E-01 1.15481639080E-01 1.15443513920E-01 1.15340538420E-01 1.15171596652E-01 1.14935657077E-01 1.14631778139E-01 1.14259113843E-01 1.13816919290E-01 1.13304556151E-01 1.12721498050E-01 1.12067335841E-01 1.11341782741E-01 1.10544679306E-01 1.09675998206E-01 1.08735848787E-01 1.07724481385E-01 1.06642291353E-01 1.05489822792E-01 1.04267771934E-01 1.02976990161E-01 1.01618486629E-01 1.00193430454E-01 9.87031524502E-02 9.71491463742E-02 9.55330696568E-02 9.38567435902E-02 9.21221529455E-02 9.03314449956E-02 8.84869279198E-02 8.65910685670E-02 8.46464895591E-02 8.26559657160E-02 8.06224197862E-02 7.85489174717E-02 7.64386617349E-02 7.42949863828E-02 7.21213489234E-02 6.99213226934E-02 6.76985882622E-02 6.54569241175E-02 6.32001966445E-02 6.09323494135E-02 5.86573917947E-02 5.63793869251E-02 5.41024390541E-02 5.18306803015E-02 4.95682568647E-02 4.73193147161E-02 4.50879848386E-02 4.28783680474E-02 4.06945194558E-02 3.85404326422E-02 3.64200235832E-02 3.43371144183E-02 3.22954171198E-02 3.02985171388E-02 2.83498571071E-02 2.64527206733E-02 2.46102165549E-02 2.28252628901E-02 2.11005719733E-02 1.94386354581E-02 1.78417101142E-02 1.63118042179E-02 1.48506646604E-02 1.34597648509E-02 1.21402934886E-02 1.08931442757E-02 9.71890663357E-03 8.61785748160E-03 7.58995412902E-03 6.63482832066E-03 5.75178146983E-03 4.93978109961E-03 4.19745850329E-03 3.52310762213E-03 2.91468512604E-03 2.36981166932E-03 1.88577428012E-03 1.45952982815E-03 1.08770950190E-03 7.66624213164E-04 4.92270834271E-04 2.60339162144E-04 6.62194936577E-05 -9.45179890160E-05 -2.24635877374E-04 -3.26518791181E-04 -4.02613391217E-04 -4.55411902388E-04 -4.87434567509E-04 -5.01211073950E-04 -4.99261003250E-04 -4.84073362010E-04 -4.58085260704E-04 -4.23659815632E-04 -3.83063358159E-04 -3.38442044476E-04 -2.91797968613E-04 -2.44964891377E-04 -1.99583708237E-04 -1.57077790236E-04 -1.18628343686E-04 -8.51499470016E-05 -5.72664365886E-05 -3.52873284618E-05 -1.91849783565E-05 -8.57270072397E-06 -2.68408636313E-06 -3.53779690032E-07 -1.72937599979E-17 2.42413918741E-17 2.71713431327E-17 2.08310725629E-17 -2.19212179242E-17 -4.95432355884E-17 8.62389876293E-18 -8.34530571270E-18 6.49540036556E-18 5.21555362964E-18 7.44788889935E-18 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 4 4 1 i j (l(j)) 5.18636205292E-02 Q_int 5.64485382112E-12 5.82840986646E-12 6.01793467098E-12 6.21362232258E-12 6.41567322034E-12 6.62429427980E-12 6.83969914475E-12 7.06210840612E-12 7.29174982780E-12 7.52885857995E-12 7.77367747975E-12 8.02645724013E-12 8.28745672650E-12 8.55694322180E-12 8.83519270027E-12 9.12249011003E-12 9.41912966489E-12 9.72541514565E-12 1.00416602112E-11 1.03681887196E-11 1.07053350600E-11 1.10534444949E-11 1.14128735135E-11 1.17839901973E-11 1.21671745965E-11 1.25628191194E-11 1.29713289346E-11 1.33931223851E-11 1.38286314175E-11 1.42783020240E-11 1.47425946991E-11 1.52219849110E-11 1.57169635891E-11 1.62280376260E-11 1.67557303971E-11 1.73005822964E-11 1.78631512897E-11 1.84440134865E-11 1.90437637292E-11 1.96630162029E-11 2.03024050642E-11 2.09625850904E-11 2.16442323501E-11 2.23480448957E-11 2.30747434779E-11 2.38250722843E-11 2.45997997007E-11 2.53997190989E-11 2.62256496483E-11 2.70784371553E-11 2.79589549291E-11 2.88681046764E-11 2.98068174242E-11 3.07760544738E-11 3.17768083848E-11 3.28101039917E-11 3.38769994533E-11 3.49785873364E-11 3.61159957343E-11 3.72903894223E-11 3.85029710506E-11 3.97549823753E-11 4.10477055306E-11 4.23824643412E-11 4.37606256783E-11 4.51836008594E-11 4.66528470928E-11 4.81698689709E-11 4.97362200098E-11 5.13535042412E-11 5.30233778541E-11 5.47475508912E-11 5.65277889999E-11 5.83659152403E-11 6.02638119523E-11 6.22234226826E-11 6.42467541755E-11 6.63358784275E-11 6.84929348090E-11 7.07201322554E-11 7.30197515286E-11 7.53941475526E-11 7.78457518252E-11 8.03770749078E-11 8.29907089959E-11 8.56893305739E-11 8.84757031555E-11 9.13526801138E-11 9.43232076029E-11 9.73903275748E-11 1.00557180895E-10 1.03827010556E-10 1.07203165003E-10 1.10689101558E-10 1.14288389963E-10 1.18004716033E-10 1.21841885432E-10 1.25803827569E-10 1.29894599623E-10 1.34118390695E-10 1.38479526100E-10 1.42982471796E-10 1.47631838952E-10 1.52432388678E-10 1.57389036894E-10 1.62506859365E-10 1.67791096901E-10 1.73247160719E-10 1.78880637987E-10 1.84697297546E-10 1.90703095813E-10 1.96904182883E-10 2.03306908826E-10 2.09917830189E-10 2.16743716710E-10 2.23791558248E-10 2.31068571942E-10 2.38582209600E-10 2.46340165330E-10 2.54350383419E-10 2.62621066464E-10 2.71160683773E-10 2.79977980041E-10 2.89081984294E-10 2.98482019144E-10 3.08187710330E-10 3.18208996573E-10 3.28556139756E-10 3.39239735426E-10 3.50270723649E-10 3.61660400207E-10 3.73420428166E-10 3.85562849816E-10 3.98100099003E-10 4.11045013858E-10 4.24410849945E-10 4.38211293828E-10 4.52460477091E-10 4.67172990799E-10 4.82363900447E-10 4.98048761376E-10 5.14243634705E-10 5.30965103776E-10 5.48230291127E-10 5.66056876031E-10 5.84463112592E-10 6.03467848435E-10 6.23090544005E-10 6.43351292488E-10 6.64270840387E-10 6.85870608762E-10 7.08172715159E-10 7.31199996259E-10 7.54976031253E-10 7.79525165987E-10 8.04872537889E-10 8.31044101699E-10 8.58066656047E-10 8.85967870887E-10 9.14776315827E-10 9.44521489374E-10 9.75233849141E-10 1.00694484302E-09 1.03968694140E-09 1.07349367036E-09 1.10839964605E-09 1.14444061011E-09 1.18165346622E-09 1.22007631795E-09 1.25974850771E-09 1.30071065706E-09 1.34300470829E-09 1.38667396733E-09 1.43176314814E-09 1.47831841841E-09 1.52638744691E-09 1.57601945219E-09 1.62726525305E-09 1.68017732052E-09 1.73480983159E-09 1.79121872464E-09 1.84946175675E-09 1.90959856280E-09 1.97169071648E-09 2.03580179340E-09 2.10199743610E-09 2.17034542127E-09 2.24091572912E-09 2.31378061504E-09 2.38901468353E-09 2.46669496457E-09 2.54690099248E-09 2.62971488734E-09 2.71522143901E-09 2.80350819396E-09 2.89466554485E-09 2.98878682307E-09 3.08596839427E-09 3.18630975696E-09 3.28991364442E-09 3.39688612978E-09 3.50733673461E-09 3.62137854105E-09 3.73912830749E-09 3.86070658813E-09 3.98623785630E-09 4.11585063194E-09 4.24967761304E-09 4.38785581153E-09 4.53052669344E-09 4.67783632372E-09 4.82993551573E-09 4.98697998554E-09 5.14913051134E-09 5.31655309795E-09 5.48941914668E-09 5.66790563081E-09 5.85219527663E-09 6.04247675044E-09 6.23894485163E-09 6.44180071205E-09 6.65125200175E-09 6.86751314157E-09 7.09080552250E-09 7.32135773224E-09 7.55940578909E-09 7.80519338346E-09 8.05897212724E-09 8.32100181120E-09 8.59155067086E-09 8.87089566091E-09 9.15932273859E-09 9.45712715627E-09 9.76461376353E-09 1.00820973191E-08 1.04099028127E-08 1.07483657978E-08 1.10978327349E-08 1.14586613456E-08 1.18312209790E-08 1.22158929895E-08 1.26130711266E-08 1.30231619381E-08 1.34465851855E-08 1.38837742741E-08 1.43351766957E-08 1.48012544866E-08 1.52824847002E-08 1.57793598950E-08 1.62923886385E-08 1.68220960271E-08 1.73690242233E-08 1.79337330105E-08 1.85168003650E-08 1.91188230477E-08 1.97404172139E-08 2.03822190439E-08 2.10448853933E-08 2.17290944649E-08 2.24355465022E-08 2.31649645055E-08 2.39180949712E-08 2.46957086552E-08 2.54986013610E-08 2.63275947536E-08 2.71835371991E-08 2.80673046330E-08 2.89798014549E-08 2.99219614538E-08 3.08947487627E-08 3.18991588438E-08 3.29362195070E-08 3.40069919599E-08 3.51125718932E-08 3.62540906004E-08 3.74327161344E-08 3.86496545015E-08 3.99061508939E-08 4.12034909628E-08 4.25430021323E-08 4.39260549559E-08 4.53540645176E-08 4.68284918780E-08 4.83508455672E-08 4.99226831268E-08 5.15456127015E-08 5.32212946819E-08 5.49514434018E-08 5.67378288895E-08 5.85822786764E-08 6.04866796643E-08 6.24529800531E-08 6.44831913312E-08 6.65793903304E-08 6.87437213475E-08 7.09783983348E-08 7.32857071616E-08 7.56680079489E-08 7.81277374802E-08 8.06674116902E-08 8.32896282344E-08 8.59970691418E-08 8.87925035540E-08 9.16787905531E-08 9.46588820805E-08 9.77358259519E-08 1.00912768969E-07 1.04192960131E-07 1.07579753953E-07 1.11076613892E-07 1.14687115878E-07 1.18414951969E-07 1.22263934115E-07 1.26237998054E-07 1.30341207322E-07 1.34577757408E-07 1.38951980030E-07 1.43468347554E-07 1.48131477563E-07 1.52946137565E-07 1.57917249857E-07 1.63049896547E-07 1.68349324738E-07 1.73820951883E-07 1.79470371306E-07 1.85303357912E-07 1.91325874072E-07 1.97544075707E-07 2.03964318564E-07 2.10593164695E-07 2.17437389151E-07 2.24503986885E-07 2.31800179889E-07 2.39333424549E-07 2.47111419249E-07 2.55142112218E-07 2.63433709627E-07 2.71994683956E-07 2.80833782621E-07 2.89960036893E-07 2.99382771096E-07 3.09111612105E-07 3.19156499156E-07 3.29527693964E-07 3.40235791178E-07 3.51291729170E-07 3.62706801173E-07 3.74492666778E-07 3.86661363805E-07 3.99225320558E-07 4.12197368476E-07 4.25590755193E-07 4.39419158015E-07 4.53696697846E-07 4.68437953549E-07 4.83657976781E-07 4.99372307304E-07 5.15596988791E-07 5.32348585143E-07 5.49644197333E-07 5.67501480796E-07 5.85938663377E-07 6.04974563862E-07 6.24628611108E-07 6.44920863784E-07 6.65872030761E-07 6.87503492148E-07 7.09837321019E-07 7.32896305829E-07 7.56703973565E-07 7.81284613634E-07 8.06663302530E-07 8.32865929295E-07 8.59919221791E-07 8.87850773841E-07 9.16689073220E-07 9.46463530568E-07 9.77204509227E-07 1.00894335604E-06 1.04171243314E-06 1.07554515078E-06 1.11047600120E-06 1.14654059356E-06 1.18377569011E-06 1.22221924336E-06 1.26191043461E-06 1.30288971356E-06 1.34519883937E-06 1.38888092288E-06 1.43398047028E-06 1.48054342820E-06 1.52861723013E-06 1.57825084453E-06 1.62949482429E-06 1.68240135787E-06 1.73702432215E-06 1.79341933681E-06 1.85164382065E-06 1.91175704954E-06 1.97382021638E-06 2.03789649289E-06 2.10405109344E-06 2.17235134086E-06 2.24286673447E-06 2.31566902019E-06 2.39083226292E-06 2.46843292133E-06 2.54854992492E-06 2.63126475363E-06 2.71666151998E-06 2.80482705387E-06 2.89585099001E-06 2.98982585828E-06 3.08684717687E-06 3.18701354846E-06 3.29042675949E-06 3.39719188252E-06 3.50741738200E-06 3.62121522328E-06 3.73870098522E-06 3.85999397636E-06 3.98521735473E-06 4.11449825163E-06 4.24796789924E-06 4.38576176235E-06 4.52801967431E-06 4.67488597729E-06 4.82650966704E-06 4.98304454222E-06 5.14464935853E-06 5.31148798778E-06 5.48372958192E-06 5.66154874241E-06 5.84512569493E-06 6.03464646962E-06 6.23030308712E-06 6.43229375048E-06 6.64082304316E-06 6.85610213336E-06 7.07834898483E-06 7.30778857435E-06 7.54465311613E-06 7.78918229330E-06 8.04162349683E-06 8.30223207188E-06 8.57127157209E-06 8.84901402183E-06 9.13574018683E-06 9.43173985327E-06 9.73731211583E-06 1.00527656747E-05 1.03784191421E-05 1.07146013584E-05 1.10616517183E-05 1.14199205072E-05 1.17897692481E-05 1.21715710599E-05 1.25657110263E-05 1.29725865768E-05 1.33926078797E-05 1.38261982468E-05 1.42737945521E-05 1.47358476622E-05 1.52128228813E-05 1.57052004095E-05 1.62134758160E-05 1.67381605266E-05 1.72797823268E-05 1.78388858808E-05 1.84160332662E-05 1.90118045258E-05 1.96267982367E-05 2.02616320968E-05 2.09169435301E-05 2.15933903104E-05 2.22916512047E-05 2.30124266362E-05 2.37564393689E-05 2.45244352124E-05 2.53171837490E-05 2.61354790837E-05 2.69801406169E-05 2.78520138413E-05 2.87519711635E-05 2.96809127510E-05 3.06397674053E-05 3.16294934620E-05 3.26510797187E-05 3.37055463913E-05 3.47939461000E-05 3.59173648856E-05 3.70769232569E-05 3.82737772702E-05 3.95091196422E-05 4.07841808968E-05 4.21002305468E-05 4.34585783123E-05 4.48605753756E-05 4.63076156750E-05 4.78011372377E-05 4.93426235531E-05 5.09336049886E-05 5.25756602473E-05 5.42704178709E-05 5.60195577877E-05 5.78248129071E-05 5.96879707630E-05 6.16108752061E-05 6.35954281478E-05 6.56435913563E-05 6.77573883062E-05 6.99389060847E-05 7.21902973538E-05 7.45137823720E-05 7.69116510760E-05 7.93862652245E-05 8.19400606062E-05 8.45755493130E-05 8.72953220808E-05 9.01020507003E-05 9.29984904979E-05 9.59874828910E-05 9.90719580184E-05 1.02254937447E-04 1.05539536961E-04 1.08928969428E-04 1.12426547754E-04 1.16035687922E-04 1.19759912120E-04 1.23602851956E-04 1.27568251779E-04 1.31659972076E-04 1.35881992986E-04 1.40238417907E-04 1.44733477205E-04 1.49371532031E-04 1.54157078255E-04 1.59094750496E-04 1.64189326286E-04 1.69445730336E-04 1.74869038933E-04 1.80464484459E-04 1.86237460032E-04 1.92193524289E-04 1.98338406289E-04 2.04678010565E-04 2.11218422312E-04 2.17965912717E-04 2.24926944438E-04 2.32108177240E-04 2.39516473777E-04 2.47158905536E-04 2.55042758950E-04 2.63175541665E-04 2.71564988990E-04 2.80219070509E-04 2.89145996883E-04 2.98354226824E-04 3.07852474266E-04 3.17649715713E-04 3.27755197798E-04 3.38178445026E-04 3.48929267732E-04 3.60017770241E-04 3.71454359240E-04 3.83249752372E-04 3.95414987045E-04 4.07961429471E-04 4.20900783934E-04 4.34245102294E-04 4.48006793726E-04 4.62198634715E-04 4.76833779282E-04 4.91925769483E-04 5.07488546151E-04 5.23536459907E-04 5.40084282441E-04 5.57147218060E-04 5.74740915515E-04 5.92881480111E-04 6.11585486097E-04 6.30869989352E-04 6.50752540366E-04 6.71251197510E-04 6.92384540623E-04 7.14171684897E-04 7.36632295074E-04 7.59786599959E-04 7.83655407254E-04 8.08260118712E-04 8.33622745616E-04 8.59765924586E-04 8.86712933725E-04 9.14487709088E-04 9.43114861503E-04 9.72619693712E-04 1.00302821788E-03 1.03436717341E-03 1.06666404516E-03 1.09994708192E-03 1.13424531534E-03 1.16958857912E-03 1.20600752856E-03 1.24353366052E-03 1.28219933364E-03 1.32203778894E-03 1.36308317078E-03 1.40537054810E-03 1.44893593608E-03 1.49381631805E-03 1.54004966773E-03 1.58767497187E-03 1.63673225310E-03 1.68726259314E-03 1.73930815633E-03 1.79291221334E-03 1.84811916531E-03 1.90497456813E-03 1.96352515701E-03 2.02381887134E-03 2.08590487970E-03 2.14983360510E-03 2.21565675045E-03 2.28342732415E-03 2.35319966586E-03 2.42502947237E-03 2.49897382362E-03 2.57509120874E-03 2.65344155221E-03 2.73408623996E-03 2.81708814553E-03 2.90251165616E-03 2.99042269877E-03 3.08088876590E-03 3.17397894139E-03 3.26976392596E-03 3.36831606248E-03 3.46970936093E-03 3.57401952311E-03 3.68132396683E-03 3.79170184973E-03 3.90523409253E-03 4.02200340177E-03 4.14209429181E-03 4.26559310617E-03 4.39258803809E-03 4.52316915019E-03 4.65742839319E-03 4.79545962360E-03 4.93735862029E-03 5.08322309981E-03 5.23315273046E-03 5.38724914485E-03 5.54561595102E-03 5.70835874188E-03 5.87558510287E-03 6.04740461780E-03 6.22392887265E-03 6.40527145723E-03 6.59154796457E-03 6.78287598790E-03 6.97937511507E-03 7.18116692021E-03 7.38837495257E-03 7.60112472222E-03 7.81954368262E-03 8.04376120975E-03 8.27390857764E-03 8.51011893014E-03 8.75252724873E-03 9.00127031613E-03 9.25648667554E-03 9.51831658528E-03 9.78690196854E-03 1.00623863582E-02 1.03449148363E-02 1.06346339678E-02 1.09316917291E-02 1.12362374296E-02 1.15484216280E-02 1.18683960414E-02 1.21963134478E-02 1.25323275813E-02 1.28765930201E-02 1.32292650667E-02 1.35904996206E-02 1.39604530418E-02 1.43392820066E-02 1.47271433541E-02 1.51241939241E-02 1.55305903842E-02 1.59464890492E-02 1.63720456880E-02 1.68074153226E-02 1.72527520139E-02 1.77082086387E-02 1.81739366539E-02 1.86500858496E-02 1.91368040905E-02 1.96342370444E-02 2.01425278992E-02 2.06618170662E-02 2.11922418707E-02 2.17339362294E-02 2.22870303144E-02 2.28516502026E-02 2.34279175121E-02 2.40159490242E-02 2.46158562899E-02 2.52277452239E-02 2.58517156817E-02 2.64878610239E-02 2.71362676640E-02 2.77970146025E-02 2.84701729454E-02 2.91558054077E-02 2.98539658027E-02 3.05646985161E-02 3.12880379649E-02 3.20240080433E-02 3.27726215528E-02 3.35338796196E-02 3.43077710976E-02 3.50942719592E-02 3.58933446721E-02 3.67049375651E-02 3.75289841820E-02 3.83654026244E-02 3.92140948846E-02 4.00749461696E-02 4.09478242159E-02 4.18325785981E-02 4.27290400305E-02 4.36370196638E-02 4.45563083788E-02 4.54866760771E-02 4.64278709713E-02 4.73796188762E-02 4.83416225027E-02 4.93135607558E-02 5.02950880395E-02 5.12858335703E-02 5.22854007011E-02 5.32933662585E-02 5.43092798958E-02 5.53326634644E-02 5.63630104054E-02 5.73997851663E-02 5.84424226435E-02 5.94903276551E-02 6.05428744474E-02 6.15994062370E-02 6.26592347943E-02 6.37216400699E-02 6.47858698683E-02 6.58511395740E-02 6.69166319320E-02 6.79814968877E-02 6.90448514907E-02 7.01057798664E-02 7.11633332589E-02 7.22165301512E-02 7.32643564653E-02 7.43057658484E-02 7.53396800479E-02 7.63649893810E-02 7.73805533029E-02 7.83852010777E-02 7.93777325567E-02 8.03569190681E-02 8.13215044226E-02 8.22702060387E-02 8.32017161916E-02 8.41147033894E-02 8.50078138801E-02 8.58796732926E-02 8.67288884148E-02 8.75540491117E-02 8.83537303847E-02 8.91264945758E-02 8.98708937168E-02 9.05854720251E-02 9.12687685471E-02 9.19193199483E-02 9.25356634509E-02 9.31163399169E-02 9.36598970745E-02 9.41648928875E-02 9.46298990623E-02 9.50535046894E-02 9.54343200157E-02 9.57709803407E-02 9.60621500310E-02 9.63065266463E-02 9.65028451674E-02 9.66498823190E-02 9.67464609754E-02 9.67914546400E-02 9.67837919850E-02 9.67224614390E-02 9.66065158091E-02 9.64350769213E-02 9.62073402644E-02 9.59225796197E-02 9.55801516590E-02 9.51795004919E-02 9.47201621423E-02 9.42017689347E-02 9.36240537671E-02 9.29868542501E-02 9.22901166880E-02 9.15338998794E-02 9.07183787122E-02 8.98438475299E-02 8.89107232438E-02 8.79195481648E-02 8.68709925327E-02 8.57658567145E-02 8.46050730491E-02 8.33897073127E-02 8.21209597810E-02 8.08001658642E-02 7.94287962923E-02 7.80084568285E-02 7.65408874901E-02 7.50279612572E-02 7.34716822508E-02 7.18741833649E-02 7.02377233361E-02 6.85646832410E-02 6.68575624078E-02 6.51189737367E-02 6.33516384231E-02 6.15583800795E-02 5.97421182588E-02 5.79058613814E-02 5.60526990713E-02 5.41857939145E-02 5.23083726499E-02 5.04237168125E-02 4.85351528475E-02 4.66460417228E-02 4.47597680656E-02 4.28797288575E-02 4.10093217238E-02 3.91519328572E-02 3.73109246203E-02 3.54896228743E-02 3.36913040860E-02 3.19191822678E-02 3.01763958090E-02 2.84659942603E-02 2.67909251352E-02 2.51540207963E-02 2.35579854942E-02 2.20053826316E-02 2.04986223230E-02 1.90399493257E-02 1.76314314129E-02 1.62749482651E-02 1.49721809499E-02 1.37246020633E-02 1.25334665997E-02 1.13998036177E-02 1.03244087630E-02 9.30783770659E-03 8.35040054968E-03 7.45215724220E-03 6.61291405297E-03 5.83222112311E-03 5.10937112476E-03 4.44339903834E-03 3.83308305110E-03 3.27694656942E-03 2.77326132614E-03 2.32005155265E-03 1.91509917423E-03 1.55594997553E-03 1.23992067180E-03 9.64106811023E-04 7.25391422395E-04 5.20454317764E-04 3.45781945900E-04 1.98011731406E-04 7.49809733923E-05 -2.52011589180E-05 -1.04466202073E-04 -1.64773147369E-04 -2.08094500064E-04 -2.36401705911E-04 -2.51650009736E-04 -2.55762818606E-04 -2.50615649963E-04 -2.38019753068E-04 -2.19705500148E-04 -1.97305651731E-04 -1.72338608846E-04 -1.46191773037E-04 -1.20105143594E-04 -9.51552899049E-05 -7.22398456296E-05 -5.20626803653E-05 -3.51199137558E-05 -2.16869466273E-05 -1.18066937740E-05 -5.27921350613E-06 -1.65294010804E-06 -2.17736928618E-07 -1.25866951190E-18 -1.07111074497E-17 1.00763440925E-17 6.70978769102E-18 1.04806989635E-17 -4.16994619495E-17 -1.19141561394E-17 3.37311947331E-18 -1.37145150817E-17 -4.85606184275E-18 -6.84792197183E-18 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2S 0 2.00 Wavefunction 1.37331834607E-03 1.38434894254E-03 1.39546813736E-03 1.40667664216E-03 1.41797517428E-03 1.42936445681E-03 1.44084521866E-03 1.45241819459E-03 1.46408412526E-03 1.47584375729E-03 1.48769784327E-03 1.49964714187E-03 1.51169241783E-03 1.52383444203E-03 1.53607399156E-03 1.54841184974E-03 1.56084880617E-03 1.57338565682E-03 1.58602320403E-03 1.59876225658E-03 1.61160362978E-03 1.62454814546E-03 1.63759663204E-03 1.65074992462E-03 1.66400886501E-03 1.67737430174E-03 1.69084709021E-03 1.70442809265E-03 1.71811817824E-03 1.73191822311E-03 1.74582911046E-03 1.75985173058E-03 1.77398698088E-03 1.78823576601E-03 1.80259899787E-03 1.81707759570E-03 1.83167248609E-03 1.84638460311E-03 1.86121488831E-03 1.87616429081E-03 1.89123376734E-03 1.90642428234E-03 1.92173680797E-03 1.93717232421E-03 1.95273181891E-03 1.96841628786E-03 1.98422673483E-03 2.00016417167E-03 2.01622961834E-03 2.03242410301E-03 2.04874866210E-03 2.06520434034E-03 2.08179219088E-03 2.09851327531E-03 2.11536866373E-03 2.13235943487E-03 2.14948667611E-03 2.16675148354E-03 2.18415496209E-03 2.20169822554E-03 2.21938239662E-03 2.23720860709E-03 2.25517799777E-03 2.27329171868E-03 2.29155092905E-03 2.30995679742E-03 2.32851050173E-03 2.34721322937E-03 2.36606617727E-03 2.38507055198E-03 2.40422756972E-03 2.42353845649E-03 2.44300444814E-03 2.46262679045E-03 2.48240673919E-03 2.50234556022E-03 2.52244452956E-03 2.54270493351E-03 2.56312806865E-03 2.58371524202E-03 2.60446777113E-03 2.62538698408E-03 2.64647421963E-03 2.66773082730E-03 2.68915816744E-03 2.71075761133E-03 2.73253054127E-03 2.75447835064E-03 2.77660244403E-03 2.79890423730E-03 2.82138515770E-03 2.84404664390E-03 2.86689014618E-03 2.88991712641E-03 2.91312905824E-03 2.93652742715E-03 2.96011373053E-03 2.98388947782E-03 3.00785619055E-03 3.03201540251E-03 3.05636865977E-03 3.08091752084E-03 3.10566355674E-03 3.13060835110E-03 3.15575350027E-03 3.18110061342E-03 3.20665131266E-03 3.23240723310E-03 3.25837002299E-03 3.28454134382E-03 3.31092287043E-03 3.33751629110E-03 3.36432330765E-03 3.39134563561E-03 3.41858500424E-03 3.44604315673E-03 3.47372185023E-03 3.50162285603E-03 3.52974795962E-03 3.55809896085E-03 3.58667767401E-03 3.61548592796E-03 3.64452556625E-03 3.67379844723E-03 3.70330644418E-03 3.73305144541E-03 3.76303535441E-03 3.79326008995E-03 3.82372758620E-03 3.85443979285E-03 3.88539867529E-03 3.91660621465E-03 3.94806440798E-03 3.97977526837E-03 4.01174082507E-03 4.04396312364E-03 4.07644422604E-03 4.10918621080E-03 4.14219117315E-03 4.17546122512E-03 4.20899849573E-03 4.24280513106E-03 4.27688329446E-03 4.31123516661E-03 4.34586294573E-03 4.38076884768E-03 4.41595510611E-03 4.45142397260E-03 4.48717771684E-03 4.52321862669E-03 4.55954900843E-03 4.59617118683E-03 4.63308750533E-03 4.67030032620E-03 4.70781203064E-03 4.74562501902E-03 4.78374171094E-03 4.82216454544E-03 4.86089598116E-03 4.89993849645E-03 4.93929458958E-03 4.97896677886E-03 5.01895760285E-03 5.05926962044E-03 5.09990541112E-03 5.14086757505E-03 5.18215873328E-03 5.22378152789E-03 5.26573862220E-03 5.30803270088E-03 5.35066647016E-03 5.39364265802E-03 5.43696401431E-03 5.48063331097E-03 5.52465334218E-03 5.56902692457E-03 5.61375689737E-03 5.65884612261E-03 5.70429748528E-03 5.75011389354E-03 5.79629827889E-03 5.84285359638E-03 5.88978282475E-03 5.93708896667E-03 5.98477504892E-03 6.03284412255E-03 6.08129926313E-03 6.13014357089E-03 6.17938017098E-03 6.22901221359E-03 6.27904287423E-03 6.32947535388E-03 6.38031287923E-03 6.43155870285E-03 6.48321610342E-03 6.53528838594E-03 6.58777888194E-03 6.64069094967E-03 6.69402797436E-03 6.74779336839E-03 6.80199057153E-03 6.85662305115E-03 6.91169430247E-03 6.96720784874E-03 7.02316724148E-03 7.07957606072E-03 7.13643791523E-03 7.19375644273E-03 7.25153531013E-03 7.30977821377E-03 7.36848887964E-03 7.42767106364E-03 7.48732855182E-03 7.54746516058E-03 7.60808473696E-03 7.66919115888E-03 7.73078833536E-03 7.79288020677E-03 7.85547074513E-03 7.91856395431E-03 7.98216387030E-03 8.04627456147E-03 8.11090012885E-03 8.17604470635E-03 8.24171246106E-03 8.30790759349E-03 8.37463433785E-03 8.44189696231E-03 8.50969976930E-03 8.57804709575E-03 8.64694331338E-03 8.71639282897E-03 8.78640008466E-03 8.85696955823E-03 8.92810576334E-03 8.99981324990E-03 9.07209660428E-03 9.14496044964E-03 9.21840944623E-03 9.29244829167E-03 9.36708172124E-03 9.44231450823E-03 9.51815146417E-03 9.59459743919E-03 9.67165732233E-03 9.74933604181E-03 9.82763856539E-03 9.90656990063E-03 9.98613509528E-03 1.00663392375E-02 1.01471874564E-02 1.02286849220E-02 1.03108368459E-02 1.03936484815E-02 1.04771251242E-02 1.05612721119E-02 1.06460948255E-02 1.07315986886E-02 1.08177891686E-02 1.09046717767E-02 1.09922520682E-02 1.10805356429E-02 1.11695281456E-02 1.12592352662E-02 1.13496627402E-02 1.14408163492E-02 1.15327019211E-02 1.16253253304E-02 1.17186924987E-02 1.18128093951E-02 1.19076820365E-02 1.20033164880E-02 1.20997188634E-02 1.21968953253E-02 1.22948520857E-02 1.23935954064E-02 1.24931315995E-02 1.25934670275E-02 1.26946081038E-02 1.27965612933E-02 1.28993331126E-02 1.30029301306E-02 1.31073589687E-02 1.32126263013E-02 1.33187388564E-02 1.34257034156E-02 1.35335268152E-02 1.36422159457E-02 1.37517777533E-02 1.38622192394E-02 1.39735474617E-02 1.40857695343E-02 1.41988926282E-02 1.43129239719E-02 1.44278708516E-02 1.45437406119E-02 1.46605406562E-02 1.47782784471E-02 1.48969615069E-02 1.50165974181E-02 1.51371938239E-02 1.52587584286E-02 1.53812989980E-02 1.55048233603E-02 1.56293394061E-02 1.57548550891E-02 1.58813784267E-02 1.60089175003E-02 1.61374804561E-02 1.62670755053E-02 1.63977109248E-02 1.65293950575E-02 1.66621363131E-02 1.67959431687E-02 1.69308241689E-02 1.70667879266E-02 1.72038431236E-02 1.73419985112E-02 1.74812629103E-02 1.76216452125E-02 1.77631543804E-02 1.79057994481E-02 1.80495895220E-02 1.81945337810E-02 1.83406414775E-02 1.84879219377E-02 1.86363845623E-02 1.87860388268E-02 1.89368942828E-02 1.90889605576E-02 1.92422473558E-02 1.93967644591E-02 1.95525217275E-02 1.97095290994E-02 1.98677965927E-02 2.00273343051E-02 2.01881524148E-02 2.03502611813E-02 2.05136709457E-02 2.06783921318E-02 2.08444352463E-02 2.10118108796E-02 2.11805297067E-02 2.13506024874E-02 2.15220400676E-02 2.16948533792E-02 2.18690534414E-02 2.20446513611E-02 2.22216583337E-02 2.24000856437E-02 2.25799446654E-02 2.27612468637E-02 2.29440037946E-02 2.31282271062E-02 2.33139285394E-02 2.35011199281E-02 2.36898132006E-02 2.38800203801E-02 2.40717535852E-02 2.42650250311E-02 2.44598470297E-02 2.46562319912E-02 2.48541924241E-02 2.50537409363E-02 2.52548902359E-02 2.54576531320E-02 2.56620425353E-02 2.58680714590E-02 2.60757530195E-02 2.62851004375E-02 2.64961270384E-02 2.67088462534E-02 2.69232716201E-02 2.71394167837E-02 2.73572954972E-02 2.75769216228E-02 2.77983091326E-02 2.80214721094E-02 2.82464247473E-02 2.84731813530E-02 2.87017563464E-02 2.89321642616E-02 2.91644197476E-02 2.93985375694E-02 2.96345326086E-02 2.98724198646E-02 3.01122144554E-02 3.03539316185E-02 3.05975867115E-02 3.08431952136E-02 3.10907727262E-02 3.13403349738E-02 3.15918978049E-02 3.18454771933E-02 3.21010892384E-02 3.23587501670E-02 3.26184763335E-02 3.28802842213E-02 3.31441904435E-02 3.34102117443E-02 3.36783649995E-02 3.39486672178E-02 3.42211355417E-02 3.44957872485E-02 3.47726397514E-02 3.50517106004E-02 3.53330174834E-02 3.56165782272E-02 3.59024107986E-02 3.61905333053E-02 3.64809639973E-02 3.67737212673E-02 3.70688236525E-02 3.73662898353E-02 3.76661386443E-02 3.79683890557E-02 3.82730601940E-02 3.85801713335E-02 3.88897418989E-02 3.92017914671E-02 3.95163397677E-02 3.98334066844E-02 4.01530122560E-02 4.04751766779E-02 4.07999203026E-02 4.11272636415E-02 4.14572273656E-02 4.17898323070E-02 4.21250994598E-02 4.24630499814E-02 4.28037051936E-02 4.31470865839E-02 4.34932158067E-02 4.38421146844E-02 4.41938052087E-02 4.45483095416E-02 4.49056500170E-02 4.52658491417E-02 4.56289295964E-02 4.59949142374E-02 4.63638260977E-02 4.67356883879E-02 4.71105244980E-02 4.74883579983E-02 4.78692126406E-02 4.82531123599E-02 4.86400812753E-02 4.90301436914E-02 4.94233240996E-02 4.98196471793E-02 5.02191377995E-02 5.06218210198E-02 5.10277220916E-02 5.14368664600E-02 5.18492797645E-02 5.22649878407E-02 5.26840167213E-02 5.31063926380E-02 5.35321420222E-02 5.39612915068E-02 5.43938679273E-02 5.48298983232E-02 5.52694099397E-02 5.57124302284E-02 5.61589868493E-02 5.66091076718E-02 5.70628207762E-02 5.75201544551E-02 5.79811372149E-02 5.84457977767E-02 5.89141650783E-02 5.93862682754E-02 5.98621367426E-02 6.03418000755E-02 6.08252880914E-02 6.13126308312E-02 6.18038585607E-02 6.22990017719E-02 6.27980911843E-02 6.33011577466E-02 6.38082326381E-02 6.43193472697E-02 6.48345332858E-02 6.53538225656E-02 6.58772472243E-02 6.64048396146E-02 6.69366323284E-02 6.74726581977E-02 6.80129502965E-02 6.85575419421E-02 6.91064666960E-02 6.96597583663E-02 7.02174510081E-02 7.07795789255E-02 7.13461766729E-02 7.19172790563E-02 7.24929211348E-02 7.30731382219E-02 7.36579658868E-02 7.42474399561E-02 7.48415965149E-02 7.54404719084E-02 7.60441027429E-02 7.66525258876E-02 7.72657784756E-02 7.78838979055E-02 7.85069218426E-02 7.91348882202E-02 7.97678352412E-02 8.04058013788E-02 8.10488253787E-02 8.16969462595E-02 8.23502033146E-02 8.30086361132E-02 8.36722845016E-02 8.43411886045E-02 8.50153888260E-02 8.56949258513E-02 8.63798406474E-02 8.70701744646E-02 8.77659688375E-02 8.84672655862E-02 8.91741068176E-02 8.98865349263E-02 9.06045925957E-02 9.13283227993E-02 9.20577688015E-02 9.27929741588E-02 9.35339827208E-02 9.42808386311E-02 9.50335863284E-02 9.57922705472E-02 9.65569363191E-02 9.73276289733E-02 9.81043941376E-02 9.88872777393E-02 9.96763260061E-02 1.00471585466E-01 1.01273102951E-01 1.02080925591E-01 1.02895100825E-01 1.03715676390E-01 1.04542700331E-01 1.05376220997E-01 1.06216287042E-01 1.07062947425E-01 1.07916251413E-01 1.08776248580E-01 1.09642988804E-01 1.10516522272E-01 1.11396899481E-01 1.12284171231E-01 1.13178388632E-01 1.14079603104E-01 1.14987866371E-01 1.15903230468E-01 1.16825747736E-01 1.17755470824E-01 1.18692452688E-01 1.19636746593E-01 1.20588406109E-01 1.21547485113E-01 1.22514037787E-01 1.23488118619E-01 1.24469782403E-01 1.25459084233E-01 1.26456079511E-01 1.27460823937E-01 1.28473373515E-01 1.29493784549E-01 1.30522113641E-01 1.31558417690E-01 1.32602753895E-01 1.33655179746E-01 1.34715753030E-01 1.35784531823E-01 1.36861574493E-01 1.37946939697E-01 1.39040686375E-01 1.40142873756E-01 1.41253561347E-01 1.42372808937E-01 1.43500676591E-01 1.44637224651E-01 1.45782513729E-01 1.46936604707E-01 1.48099558733E-01 1.49271437218E-01 1.50452301834E-01 1.51642214509E-01 1.52841237422E-01 1.54049433005E-01 1.55266863931E-01 1.56493593118E-01 1.57729683719E-01 1.58975199119E-01 1.60230202933E-01 1.61494758999E-01 1.62768931370E-01 1.64052784318E-01 1.65346382317E-01 1.66649790046E-01 1.67963072382E-01 1.69286294390E-01 1.70619521319E-01 1.71962818598E-01 1.73316251827E-01 1.74679886768E-01 1.76053789344E-01 1.77438025623E-01 1.78832661820E-01 1.80237764281E-01 1.81653399480E-01 1.83079634008E-01 1.84516534566E-01 1.85964167952E-01 1.87422601057E-01 1.88891900855E-01 1.90372134388E-01 1.91863368759E-01 1.93365671124E-01 1.94879108676E-01 1.96403748638E-01 1.97939658249E-01 1.99486904754E-01 2.01045555389E-01 2.02615677371E-01 2.04197337885E-01 2.05790604066E-01 2.07395542993E-01 2.09012221669E-01 2.10640707006E-01 2.12281065815E-01 2.13933364787E-01 2.15597670475E-01 2.17274049282E-01 2.18962567443E-01 2.20663291006E-01 2.22376285816E-01 2.24101617495E-01 2.25839351425E-01 2.27589552728E-01 2.29352286245E-01 2.31127616519E-01 2.32915607769E-01 2.34716323874E-01 2.36529828347E-01 2.38356184314E-01 2.40195454491E-01 2.42047701159E-01 2.43912986141E-01 2.45791370776E-01 2.47682915894E-01 2.49587681787E-01 2.51505728189E-01 2.53437114237E-01 2.55381898455E-01 2.57340138716E-01 2.59311892214E-01 2.61297215436E-01 2.63296164130E-01 2.65308793269E-01 2.67335157025E-01 2.69375308728E-01 2.71429300837E-01 2.73497184900E-01 2.75579011524E-01 2.77674830331E-01 2.79784689926E-01 2.81908637853E-01 2.84046720561E-01 2.86198983357E-01 2.88365470371E-01 2.90546224507E-01 2.92741287406E-01 2.94950699395E-01 2.97174499448E-01 2.99412725134E-01 3.01665412573E-01 3.03932596387E-01 3.06214309647E-01 3.08510583827E-01 3.10821448751E-01 3.13146932537E-01 3.15487061545E-01 3.17841860325E-01 3.20211351555E-01 3.22595555985E-01 3.24994492382E-01 3.27408177466E-01 3.29836625848E-01 3.32279849974E-01 3.34737860053E-01 3.37210663996E-01 3.39698267352E-01 3.42200673236E-01 3.44717882263E-01 3.47249892474E-01 3.49796699271E-01 3.52358295338E-01 3.54934670567E-01 3.57525811988E-01 3.60131703683E-01 3.62752326715E-01 3.65387659045E-01 3.68037675448E-01 3.70702347436E-01 3.73381643167E-01 3.76075527364E-01 3.78783961224E-01 3.81506902334E-01 3.84244304575E-01 3.86996118033E-01 3.89762288906E-01 3.92542759407E-01 3.95337467670E-01 3.98146347652E-01 4.00969329029E-01 4.03806337102E-01 4.06657292689E-01 4.09522112024E-01 4.12400706648E-01 4.15292983306E-01 4.18198843838E-01 4.21118185064E-01 4.24050898679E-01 4.26996871135E-01 4.29955983531E-01 4.32928111491E-01 4.35913125053E-01 4.38910888546E-01 4.41921260473E-01 4.44944093387E-01 4.47979233768E-01 4.51026521901E-01 4.54085791751E-01 4.57156870833E-01 4.60239580087E-01 4.63333733750E-01 4.66439139224E-01 4.69555596943E-01 4.72682900246E-01 4.75820835242E-01 4.78969180674E-01 4.82127707788E-01 4.85296180194E-01 4.88474353732E-01 4.91661976336E-01 4.94858787895E-01 4.98064520117E-01 5.01278896390E-01 5.04501631644E-01 5.07732432212E-01 5.10970995695E-01 5.14217010819E-01 5.17470157300E-01 5.20730105705E-01 5.23996517314E-01 5.27269043988E-01 5.30547328024E-01 5.33831002029E-01 5.37119688779E-01 5.40413001091E-01 5.43710541688E-01 5.47011903071E-01 5.50316667388E-01 5.53624406311E-01 5.56934680908E-01 5.60247041522E-01 5.63561027655E-01 5.66876167845E-01 5.70191979555E-01 5.73507969064E-01 5.76823631356E-01 5.80138450020E-01 5.83451897147E-01 5.86763433237E-01 5.90072507106E-01 5.93378555803E-01 5.96681004524E-01 5.99979266543E-01 6.03272743135E-01 6.06560823518E-01 6.09842884792E-01 6.13118291888E-01 6.16386397529E-01 6.19646542187E-01 6.22898054060E-01 6.26140249049E-01 6.29372430747E-01 6.32593890438E-01 6.35803907100E-01 6.39001747426E-01 6.42186665846E-01 6.45357904568E-01 6.48514693626E-01 6.51656250939E-01 6.54781782383E-01 6.57890481876E-01 6.60981531473E-01 6.64054101481E-01 6.67107350579E-01 6.70140425960E-01 6.73152463481E-01 6.76142587834E-01 6.79109912729E-01 6.82053541097E-01 6.84972565303E-01 6.87866067380E-01 6.90733119287E-01 6.93572783170E-01 6.96384111656E-01 6.99166148155E-01 7.01917927191E-01 7.04638474744E-01 7.07326808617E-01 7.09981938822E-01 7.12602867985E-01 7.15188591778E-01 7.17738099365E-01 7.20250373875E-01 7.22724392891E-01 7.25159128973E-01 7.27553550186E-01 7.29906620666E-01 7.32217301202E-01 7.34484549838E-01 7.36707322502E-01 7.38884573657E-01 7.41015256971E-01 7.43098326015E-01 7.45132734975E-01 7.47117439395E-01 7.49051396931E-01 7.50933568136E-01 7.52762917257E-01 7.54538413055E-01 7.56259029643E-01 7.57923747343E-01 7.59531553560E-01 7.61081443666E-01 7.62572421907E-01 7.64003502317E-01 7.65373709650E-01 7.66682080309E-01 7.67927663301E-01 7.69109521183E-01 7.70226731021E-01 7.71278385347E-01 7.72263593115E-01 7.73181480659E-01 7.74031192635E-01 7.74811892966E-01 7.75522765761E-01 7.76163016234E-01 7.76731871585E-01 7.77228581875E-01 7.77652420861E-01 7.78002686805E-01 7.78278703245E-01 7.78479819722E-01 7.78605412464E-01 7.78654885018E-01 7.78627668818E-01 7.78523223697E-01 7.78341038328E-01 7.78080630580E-01 7.77741547803E-01 7.77323367017E-01 7.76825695002E-01 7.76248168286E-01 7.75590453020E-01 7.74852244733E-01 7.74033267956E-01 7.73133275711E-01 7.72152048850E-01 7.71089395245E-01 7.69945148810E-01 7.68719168349E-01 7.67411336223E-01 7.66021556823E-01 7.64549754847E-01 7.62995873356E-01 7.61359871612E-01 7.59641722693E-01 7.57841410855E-01 7.55958928652E-01 7.53994273792E-01 7.51947445728E-01 7.49818441972E-01 7.47607254114E-01 7.45313863557E-01 7.42938236947E-01 7.40480321291E-01 7.37940038758E-01 7.35317281169E-01 7.32611904144E-01 7.29823720932E-01 7.26952495906E-01 7.23997937713E-01 7.20959692101E-01 7.17837334402E-01 7.14630361687E-01 7.11338184594E-01 7.07960118830E-01 7.04495376359E-01 7.00943056291E-01 6.97302135474E-01 6.93571458811E-01 6.89750213476E-01 6.85839434204E-01 6.81840655380E-01 6.77755441366E-01 6.73585385653E-01 6.69332110008E-01 6.64997263602E-01 6.60582522119E-01 6.56089586860E-01 6.51520183826E-01 6.46876062790E-01 6.42158996364E-01 6.37370779042E-01 6.32513226247E-01 6.27588173356E-01 6.22597474723E-01 6.17543002691E-01 6.12426646598E-01 6.07250311771E-01 6.02015918524E-01 5.96725401134E-01 5.91380706832E-01 5.85982461154E-01 5.80533957066E-01 5.75037174403E-01 5.69494101815E-01 5.63906735741E-01 5.58277079363E-01 5.52607141573E-01 5.46898935933E-01 5.41154479638E-01 5.35375792478E-01 5.29564895808E-01 5.23723811510E-01 5.17854560965E-01 5.11959164031E-01 5.06039638015E-01 5.00097996661E-01 4.94136249135E-01 4.88156399018E-01 4.82160443310E-01 4.76150371431E-01 4.70128164240E-01 4.64095793055E-01 4.58055218682E-01 4.52008390459E-01 4.45957245299E-01 4.39903706753E-01 4.33849684080E-01 4.27797071323E-01 4.21747746408E-01 4.15703570240E-01 4.09666385828E-01 4.03638017409E-01 3.97620269593E-01 3.91614926523E-01 3.85623751043E-01 3.79648483888E-01 3.73690842887E-01 3.67752522180E-01 3.61835191454E-01 3.55940495196E-01 3.50070051962E-01 3.44225453667E-01 3.38408264889E-01 3.32620022192E-01 3.26862233479E-01 3.21136377346E-01 3.15443902475E-01 3.09786227034E-01 3.04164738106E-01 2.98580791138E-01 2.93035709410E-01 2.87530783527E-01 2.82067270936E-01 2.76646395463E-01 2.71269346877E-01 2.65937280478E-01 2.60651316701E-01 2.55412540760E-01 2.50222002302E-01 2.45080715096E-01 2.39989656742E-01 2.34949768413E-01 2.29961954612E-01 2.25027082967E-01 2.20145984047E-01 2.15319451203E-01 2.10548240440E-01 2.05833070319E-01 2.01174621874E-01 1.96573538571E-01 1.92030426287E-01 1.87545853317E-01 1.83120350412E-01 1.78754410837E-01 1.74448490468E-01 1.70203007909E-01 1.66018344636E-01 1.61894845173E-01 1.57832817293E-01 1.53832532245E-01 1.49894225008E-01 1.46018094577E-01 1.42204304268E-01 1.38452982053E-01 1.34764220921E-01 1.31138079263E-01 1.27574581282E-01 1.24073717433E-01 1.20635444877E-01 1.17259687967E-01 1.13946338756E-01 1.10695257523E-01 1.07506273327E-01 1.04379184579E-01 1.01313759634E-01 9.83097374069E-02 9.53668280026E-02 9.24847133706E-02 8.96630479728E-02 8.69014594700E-02 8.41995494256E-02 8.15568940234E-02 7.89730448008E-02 7.64475293953E-02 7.39798523044E-02 7.15694956565E-02 6.92159199941E-02 6.69185650652E-02 6.46768506259E-02 6.24901772494E-02 6.03579271428E-02 5.82794649699E-02 5.62541386794E-02 5.42812803368E-02 5.23602069593E-02 5.04902213536E-02 4.86706129536E-02 4.69006586591E-02 4.51796236732E-02 4.35067623374E-02 4.18813189647E-02 4.03025286679E-02 3.87696181831E-02 3.72818066880E-02 3.58383066124E-02 3.44383244423E-02 3.30810615136E-02 3.17657147982E-02 3.04914776782E-02 2.92575407095E-02 2.80630923734E-02 2.69073198152E-02 2.57894095691E-02 2.47085482690E-02 2.36639233439E-02 2.26547236977E-02 2.16801403729E-02 2.07393671970E-02 1.98316014112E-02 1.89560442815E-02 1.81119016904E-02 1.72983847109E-02 1.65147101590E-02 1.57601011285E-02 1.50337875037E-02 1.43350064528E-02 1.36630028999E-02 1.30170299762E-02 1.23963494494E-02 1.18002321326E-02 1.12279582711E-02 1.06788179075E-02 1.01521112256E-02 9.64714887239E-03 9.16325225839E-03 8.69975383686E-03 8.25599736115E-03 7.83133812107E-03 7.42514315814E-03 7.03679145996E-03 6.66567413398E-03 6.31119456101E-03 5.97276852866E-03 5.64982434513E-03 5.34180293377E-03 5.04815790863E-03 4.76835563168E-03 4.50187525189E-03 4.24820872682E-03 4.00686082712E-03 3.77734912452E-03 3.55920396372E-03 3.35196841888E-03 3.15519823519E-03 2.96846175599E-03 2.79133983632E-03 2.62342574311E-03 2.46432504293E-03 2.31365547778E-03 2.17104682952E-03 2.03614077357E-03 1.90859072258E-03 1.78806166059E-03 1.67422996830E-03 1.56678324025E-03 1.46542009419E-03 1.36984997363E-03 1.27979294392E-03 1.19497948244E-03 1.11515026376E-03 1.04005594001E-03 9.69456917232E-04 9.03123128243E-04 8.40833802480E-04 7.82377233427E-04 7.27550544094E-04 6.76159451064E-04 6.28018027583E-04 5.82948466153E-04 5.40780841081E-04 5.01352871408E-04 4.64509684626E-04 4.30103581580E-04 3.97993802918E-04 3.68046297447E-04 3.40133492728E-04 3.14134068221E-04 2.89932731272E-04 2.67419996223E-04 2.46491966890E-04 2.27050122653E-04 2.09001108365E-04 1.92256528286E-04 1.76732744216E-04 1.62350677989E-04 1.49035618460E-04 1.36717033135E-04 1.25328384518E-04 1.14806951296E-04 1.05093654424E-04 9.61328881625E-05 8.78723561340E-05 8.02629124073E-05 7.32584076411E-05 6.68155402849E-05 6.08937128316E-05 5.54548931007E-05 5.04634805227E-05 4.58861773827E-05 4.16918649731E-05 3.78514845954E-05 3.43379233413E-05 3.11259045857E-05 2.81918830960E-05 2.55139446769E-05 2.30717102546E-05 2.08462442990E-05 1.88199674813E-05 1.69765734556E-05 1.53009496558E-05 1.37791019898E-05 1.23980833158E-05 1.11459255808E-05 1.00115755000E-05 8.98483365456E-06 8.05629689588E-06 7.21730391613E-06 6.45988387531E-06 5.77670796059E-06 5.16105297602E-06 4.60683143531E-06 4.10837499208E-06 3.66048310025E-06 3.25839783609E-06 2.89777032489E-06 2.57462934681E-06 2.28535200965E-06 2.02663638130E-06 1.79547597791E-06 1.58913600721E-06 1.40513126978E-06 1.24120562479E-06 1.09531292987E-06 9.65599368725E-07 8.50387083181E-07 7.48159030168E-07 6.57544987458E-07 5.77308635424E-07 5.06335645502E-07 4.43622709318E-07 3.88267445762E-07 3.39459126427E-07 2.96470162998E-07 2.58648303194E-07 2.25409484832E-07 1.96231300450E-07 1.70647027715E-07 1.48240183522E-07 1.28639562311E-07 1.11514721618E-07 9.65718803257E-08 8.35501973822E-08 7.22184010422E-08 6.23717408373E-08 5.38292365910E-08 4.64312008312E-08 4.00370129303E-08 3.45231252419E-08 2.97322704208E-08 2.55747452104E-08 2.19712886982E-08 1.88519546597E-08 1.61550950039E-08 1.38264445960E-08 1.18182984525E-08 1.00887729820E-08 8.60114358935E-09 7.32325156112E-09 6.22697371691E-09 5.28774884151E-09 4.48415540855E-09 3.79753556887E-09 3.21166080814E-09 2.71243507902E-09 2.28763158520E-09 1.92665973923E-09 1.62035913495E-09 1.36081766924E-09 1.14121121888E-09 9.55662527438E-10 7.99117186029E-10 6.67234800926E-10 5.56293633080E-10 4.63107169240E-10 3.84951243885E-10 3.19500476100E-10 2.64772917151E-10 2.19081923768E-10 1.80994379977E-10 1.49294487753E-10 1.22952434475E-10 1.01097324139E-10 8.29938301205E-11 6.80220908188E-11 5.56604263059E-11 4.54705048342E-11 3.70846332505E-11 3.01948855702E-11 2.45438196568E-11 1.99165635770E-11 1.61340811761E-11 1.30474511064E-11 1.05330152964E-11 8.48827197867E-12 6.82840518161E-12 5.48335729513E-12 4.39536417922E-12 3.51688349887E-12 2.80885673802E-12 2.23925383417E-12 1.78185673768E-12 1.41524457366E-12 1.12194858994E-12 8.87749821210E-13 7.01096483430E-13 5.52621618992E-13 4.34744517746E-13 3.41342008018E-13 2.67477904024E-13 2.09180762798E-13 1.63261689968E-13 1.27165278681E-13 9.88479040637E-14 7.66785564236E-14 5.93582059524E-14 4.58543722356E-14 3.53481427373E-14 2.71913622558E-14 2.08721143939E-14 1.59869486180E-14 1.22185829553E-14 9.31804173260E-15 7.09037759180E-15 5.38328378047E-15 4.07803187263E-15 3.08227624171E-15 2.32435367342E-15 1.74877774073E-15 1.31268570710E-15 9.83043071062E-16 7.34449327544E-16 5.47419691442E-16 4.07042727877E-16 3.01934155792E-16 2.23423440467E-16 1.64922910471E-16 1.21439637122E-16 8.91987006974E-17 6.53531470307E-17 4.77612445893E-17 3.48158570354E-17 2.53140697344E-17 1.83578286123E-17 1.32784097163E-17 9.57915321821E-18 6.89215899732E-18 4.94562641560E-18 3.53928750510E-18 2.52597753328E-18 1.79784705442E-18 1.27607458309E-18 9.03212191253E-19 6.37505922099E-19 4.48693276050E-19 3.14902371444E-19 2.20370460979E-19 1.53770092471E-19 1.06984609088E-19 7.42149623554E-20 5.13300989251E-20 3.53958898169E-20 2.43345449392E-20 1.66791056460E-20 1.13970069957E-20 7.76366342906E-21 5.27217274983E-21 3.56901804861E-21 2.40842474423E-21 1.62006185896E-21 1.08625843841E-21 7.25983175149E-22 4.83615781045E-22 3.21102350792E-22 2.12492753832E-22 1.40149256154E-22 9.21237954245E-23 6.03497432920E-23 3.93994123083E-23 2.56331990113E-23 1.66189110886E-23 1.07368491858E-23 6.91215424999E-24 4.43404317097E-24 2.83415690201E-24 1.80498163321E-24 1.14533875819E-24 7.24093496914E-25 4.56081020539E-25 2.86195668222E-25 1.78914175985E-25 1.11422762257E-25 6.91253409593E-26 4.27190384685E-26 2.62974101439E-26 1.61249442814E-26 9.84835038440E-27 5.99094000698E-27 3.62976687564E-27 2.19028556106E-27 1.31627562956E-27 7.87776042348E-28 4.69520053442E-28 2.78667599258E-28 1.64696795054E-28 9.69249158566E-29 5.67966188794E-29 3.31383844431E-29 1.92507162831E-29 1.11340703070E-29 6.41116862522E-30 3.67520155381E-30 2.09734689404E-30 1.19148564603E-30 6.73784436927E-31 3.79272010432E-31 2.12501591001E-31 1.18505617904E-31 6.57755835868E-32 3.63348209372E-32 1.99754823545E-32 1.09287558171E-32 5.95013051353E-33 3.22364769780E-33 1.73786813157E-33 9.32216845030E-34 4.97542897133E-34 2.64204377660E-34 1.39581441073E-34 7.33627647457E-35 3.83588921232E-35 1.99517337431E-35 1.03228868012E-35 5.31262549552E-36 2.71948192865E-36 1.38456505491E-36 7.01086968780E-37 3.53055301449E-37 1.76809955347E-37 8.80530682739E-38 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2P 1 2.00 Wavefunction 1.85453035732E-06 1.88444146232E-06 1.91483499308E-06 1.94571873048E-06 1.97710058086E-06 2.00898857810E-06 2.04139088564E-06 2.07431579860E-06 2.10777174587E-06 2.14176729230E-06 2.17631114087E-06 2.21141213494E-06 2.24707926047E-06 2.28332164838E-06 2.32014857685E-06 2.35756947370E-06 2.39559391881E-06 2.43423164657E-06 2.47349254836E-06 2.51338667511E-06 2.55392423985E-06 2.59511562032E-06 2.63697136165E-06 2.67950217904E-06 2.72271896053E-06 2.76663276973E-06 2.81125484872E-06 2.85659662090E-06 2.90266969388E-06 2.94948586252E-06 2.99705711188E-06 3.04539562035E-06 3.09451376273E-06 3.14442411339E-06 3.19513944952E-06 3.24667275439E-06 3.29903722066E-06 3.35224625378E-06 3.40631347538E-06 3.46125272682E-06 3.51707807269E-06 3.57380380441E-06 3.63144444390E-06 3.69001474730E-06 3.74952970874E-06 3.81000456419E-06 3.87145479534E-06 3.93389613359E-06 3.99734456404E-06 4.06181632963E-06 4.12732793525E-06 4.19389615200E-06 4.26153802147E-06 4.33027086010E-06 4.40011226361E-06 4.47108011153E-06 4.54319257173E-06 4.61646810513E-06 4.69092547036E-06 4.76658372862E-06 4.84346224853E-06 4.92158071109E-06 5.00095911472E-06 5.08161778038E-06 5.16357735680E-06 5.24685882569E-06 5.33148350720E-06 5.41747306532E-06 5.50484951345E-06 5.59363522002E-06 5.68385291423E-06 5.77552569188E-06 5.86867702122E-06 5.96333074905E-06 6.05951110675E-06 6.15724271652E-06 6.25655059766E-06 6.35746017302E-06 6.45999727542E-06 6.56418815438E-06 6.67005948273E-06 6.77763836352E-06 6.88695233688E-06 6.99802938716E-06 7.11089795001E-06 7.22558691973E-06 7.34212565659E-06 7.46054399442E-06 7.58087224821E-06 7.70314122185E-06 7.82738221608E-06 7.95362703642E-06 8.08190800138E-06 8.21225795070E-06 8.34471025376E-06 8.47929881812E-06 8.61605809822E-06 8.75502310417E-06 8.89622941071E-06 9.03971316637E-06 9.18551110266E-06 9.33366054348E-06 9.48419941473E-06 9.63716625396E-06 9.79260022024E-06 9.95054110421E-06 1.01110293383E-05 1.02741060069E-05 1.04398128571E-05 1.06081923093E-05 1.07792874681E-05 1.09531421331E-05 1.11298008105E-05 1.13093087241E-05 1.14917118273E-05 1.16770568143E-05 1.18653911328E-05 1.20567629953E-05 1.22512213922E-05 1.24488161038E-05 1.26495977134E-05 1.28536176199E-05 1.30609280513E-05 1.32715820779E-05 1.34856336258E-05 1.37031374911E-05 1.39241493532E-05 1.41487257898E-05 1.43769242909E-05 1.46088032739E-05 1.48444220980E-05 1.50838410801E-05 1.53271215095E-05 1.55743256642E-05 1.58255168265E-05 1.60807592993E-05 1.63401184226E-05 1.66036605900E-05 1.68714532661E-05 1.71435650033E-05 1.74200654598E-05 1.77010254170E-05 1.79865167980E-05 1.82766126858E-05 1.85713873418E-05 1.88709162253E-05 1.91752760126E-05 1.94845446163E-05 1.97988012058E-05 2.01181262272E-05 2.04426014238E-05 2.07723098574E-05 2.11073359293E-05 2.14477654019E-05 2.17936854208E-05 2.21451845370E-05 2.25023527293E-05 2.28652814281E-05 2.32340635378E-05 2.36087934613E-05 2.39895671241E-05 2.43764819983E-05 2.47696371282E-05 2.51691331554E-05 2.55750723444E-05 2.59875586088E-05 2.64066975384E-05 2.68325964253E-05 2.72653642923E-05 2.77051119202E-05 2.81519518764E-05 2.86059985435E-05 2.90673681487E-05 2.95361787938E-05 3.00125504850E-05 3.04966051637E-05 3.09884667380E-05 3.14882611140E-05 3.19961162282E-05 3.25121620806E-05 3.30365307672E-05 3.35693565144E-05 3.41107757131E-05 3.46609269539E-05 3.52199510621E-05 3.57879911340E-05 3.63651925736E-05 3.69517031296E-05 3.75476729333E-05 3.81532545370E-05 3.87686029531E-05 3.93938756938E-05 4.00292328111E-05 4.06748369381E-05 4.13308533305E-05 4.19974499088E-05 4.26747973015E-05 4.33630688882E-05 4.40624408447E-05 4.47730921877E-05 4.54952048204E-05 4.62289635796E-05 4.69745562822E-05 4.77321737742E-05 4.85020099787E-05 4.92842619459E-05 5.00791299037E-05 5.08868173083E-05 5.17075308970E-05 5.25414807405E-05 5.33888802969E-05 5.42499464664E-05 5.51248996465E-05 5.60139637888E-05 5.69173664557E-05 5.78353388792E-05 5.87681160196E-05 5.97159366262E-05 6.06790432975E-05 6.16576825440E-05 6.26521048510E-05 6.36625647426E-05 6.46893208468E-05 6.57326359619E-05 6.67927771235E-05 6.78700156728E-05 6.89646273259E-05 7.00768922448E-05 7.12070951085E-05 7.23555251861E-05 7.35224764107E-05 7.47082474546E-05 7.59131418057E-05 7.71374678452E-05 7.83815389261E-05 7.96456734539E-05 8.09301949676E-05 8.22354322225E-05 8.35617192745E-05 8.49093955653E-05 8.62788060092E-05 8.76703010814E-05 8.90842369078E-05 9.05209753555E-05 9.19808841259E-05 9.34643368486E-05 9.49717131766E-05 9.65033988837E-05 9.80597859630E-05 9.96412727274E-05 1.01248263911E-04 1.02881170772E-04 1.04540411201E-04 1.06226409823E-04 1.07939598109E-04 1.09680414486E-04 1.11449304449E-04 1.13246720675E-04 1.15073123137E-04 1.16928979224E-04 1.18814763859E-04 1.20730959622E-04 1.22678056870E-04 1.24656553866E-04 1.26666956905E-04 1.28709780442E-04 1.30785547226E-04 1.32894788433E-04 1.35038043798E-04 1.37215861758E-04 1.39428799592E-04 1.41677423557E-04 1.43962309042E-04 1.46284040706E-04 1.48643212636E-04 1.51040428491E-04 1.53476301660E-04 1.55951455421E-04 1.58466523095E-04 1.61022148211E-04 1.63618984670E-04 1.66257696913E-04 1.68938960088E-04 1.71663460224E-04 1.74431894407E-04 1.77244970958E-04 1.80103409612E-04 1.83007941703E-04 1.85959310351E-04 1.88958270653E-04 1.92005589873E-04 1.95102047638E-04 1.98248436142E-04 2.01445560342E-04 2.04694238166E-04 2.07995300725E-04 2.11349592518E-04 2.14757971656E-04 2.18221310073E-04 2.21740493757E-04 2.25316422967E-04 2.28950012470E-04 2.32642191771E-04 2.36393905352E-04 2.40206112911E-04 2.44079789610E-04 2.48015926319E-04 2.52015529874E-04 2.56079623330E-04 2.60209246227E-04 2.64405454847E-04 2.68669322491E-04 2.73001939752E-04 2.77404414787E-04 2.81877873608E-04 2.86423460363E-04 2.91042337630E-04 2.95735686714E-04 3.00504707947E-04 3.05350620997E-04 3.10274665175E-04 3.15278099752E-04 3.20362204282E-04 3.25528278927E-04 3.30777644788E-04 3.36111644241E-04 3.41531641284E-04 3.47039021875E-04 3.52635194298E-04 3.58321589508E-04 3.64099661507E-04 3.69970887710E-04 3.75936769318E-04 3.81998831706E-04 3.88158624811E-04 3.94417723521E-04 4.00777728082E-04 4.07240264506E-04 4.13806984978E-04 4.20479568286E-04 4.27259720240E-04 4.34149174111E-04 4.41149691072E-04 4.48263060646E-04 4.55491101158E-04 4.62835660203E-04 4.70298615112E-04 4.77881873433E-04 4.85587373412E-04 4.93417084491E-04 5.01373007805E-04 5.09457176693E-04 5.17671657213E-04 5.26018548669E-04 5.34499984147E-04 5.43118131051E-04 5.51875191660E-04 5.60773403683E-04 5.69815040832E-04 5.79002413396E-04 5.88337868829E-04 5.97823792349E-04 6.07462607540E-04 6.17256776968E-04 6.27208802809E-04 6.37321227481E-04 6.47596634294E-04 6.58037648099E-04 6.68646935959E-04 6.79427207825E-04 6.90381217223E-04 7.01511761952E-04 7.12821684795E-04 7.24313874239E-04 7.35991265205E-04 7.47856839799E-04 7.59913628060E-04 7.72164708732E-04 7.84613210044E-04 7.97262310502E-04 8.10115239694E-04 8.23175279108E-04 8.36445762963E-04 8.49930079053E-04 8.63631669606E-04 8.77554032151E-04 8.91700720410E-04 9.06075345190E-04 9.20681575301E-04 9.35523138479E-04 9.50603822336E-04 9.65927475310E-04 9.81498007642E-04 9.97319392362E-04 1.01339566629E-03 1.02973093108E-03 1.04632935419E-03 1.06319517003E-03 1.08033268095E-03 1.09774625836E-03 1.11544034384E-03 1.13341945022E-03 1.15168816278E-03 1.17025114036E-03 1.18911311653E-03 1.20827890084E-03 1.22775337994E-03 1.24754151891E-03 1.26764836242E-03 1.28807903608E-03 1.30883874767E-03 1.32993278846E-03 1.35136653459E-03 1.37314544835E-03 1.39527507960E-03 1.41776106716E-03 1.44060914020E-03 1.46382511971E-03 1.48741491994E-03 1.51138454991E-03 1.53574011489E-03 1.56048781792E-03 1.58563396143E-03 1.61118494874E-03 1.63714728571E-03 1.66352758238E-03 1.69033255457E-03 1.71756902562E-03 1.74524392808E-03 1.77336430541E-03 1.80193731378E-03 1.83097022386E-03 1.86047042260E-03 1.89044541511E-03 1.92090282652E-03 1.95185040386E-03 1.98329601805E-03 2.01524766580E-03 2.04771347164E-03 2.08070168993E-03 2.11422070692E-03 2.14827904282E-03 2.18288535394E-03 2.21804843486E-03 2.25377722055E-03 2.29008078865E-03 2.32696836170E-03 2.36444930944E-03 2.40253315111E-03 2.44122955783E-03 2.48054835498E-03 2.52049952467E-03 2.56109320814E-03 2.60233970836E-03 2.64424949247E-03 2.68683319447E-03 2.73010161778E-03 2.77406573791E-03 2.81873670520E-03 2.86412584754E-03 2.91024467316E-03 2.95710487347E-03 3.00471832595E-03 3.05309709704E-03 3.10225344512E-03 3.15219982352E-03 3.20294888357E-03 3.25451347769E-03 3.30690666258E-03 3.36014170235E-03 3.41423207183E-03 3.46919145982E-03 3.52503377245E-03 3.58177313656E-03 3.63942390316E-03 3.69800065093E-03 3.75751818973E-03 3.81799156426E-03 3.87943605766E-03 3.94186719528E-03 4.00530074838E-03 4.06975273800E-03 4.13523943881E-03 4.20177738309E-03 4.26938336467E-03 4.33807444301E-03 4.40786794734E-03 4.47878148079E-03 4.55083292467E-03 4.62404044271E-03 4.69842248552E-03 4.77399779491E-03 4.85078540845E-03 4.92880466404E-03 5.00807520445E-03 5.08861698212E-03 5.17045026385E-03 5.25359563563E-03 5.33807400761E-03 5.42390661897E-03 5.51111504305E-03 5.59972119242E-03 5.68974732408E-03 5.78121604473E-03 5.87415031611E-03 5.96857346040E-03 6.06450916575E-03 6.16198149180E-03 6.26101487539E-03 6.36163413625E-03 6.46386448282E-03 6.56773151815E-03 6.67326124590E-03 6.78048007635E-03 6.88941483261E-03 7.00009275678E-03 7.11254151635E-03 7.22678921054E-03 7.34286437683E-03 7.46079599754E-03 7.58061350650E-03 7.70234679584E-03 7.82602622281E-03 7.95168261679E-03 8.07934728627E-03 8.20905202607E-03 8.34082912451E-03 8.47471137080E-03 8.61073206247E-03 8.74892501287E-03 8.88932455885E-03 9.03196556847E-03 9.17688344886E-03 9.32411415414E-03 9.47369419349E-03 9.62566063929E-03 9.78005113538E-03 9.93690390543E-03 1.00962577614E-02 1.02581521121E-02 1.04226269720E-02 1.05897229698E-02 1.07594813576E-02 1.09319440198E-02 1.11071534821E-02 1.12851529210E-02 1.14659861731E-02 1.16496977445E-02 1.18363328202E-02 1.20259372744E-02 1.22185576797E-02 1.24142413174E-02 1.26130361874E-02 1.28149910186E-02 1.30201552788E-02 1.32285791856E-02 1.34403137166E-02 1.36554106202E-02 1.38739224264E-02 1.40959024574E-02 1.43214048392E-02 1.45504845123E-02 1.47831972431E-02 1.50195996353E-02 1.52597491413E-02 1.55037040741E-02 1.57515236187E-02 1.60032678445E-02 1.62589977167E-02 1.65187751088E-02 1.67826628147E-02 1.70507245612E-02 1.73230250204E-02 1.75996298223E-02 1.78806055677E-02 1.81660198407E-02 1.84559412219E-02 1.87504393016E-02 1.90495846928E-02 1.93534490446E-02 1.96621050556E-02 1.99756264873E-02 2.02940881783E-02 2.06175660574E-02 2.09461371578E-02 2.12798796312E-02 2.16188727616E-02 2.19631969797E-02 2.23129338772E-02 2.26681662209E-02 2.30289779678E-02 2.33954542788E-02 2.37676815344E-02 2.41457473486E-02 2.45297405840E-02 2.49197513672E-02 2.53158711031E-02 2.57181924904E-02 2.61268095366E-02 2.65418175732E-02 2.69633132713E-02 2.73913946564E-02 2.78261611241E-02 2.82677134556E-02 2.87161538330E-02 2.91715858548E-02 2.96341145517E-02 3.01038464019E-02 3.05808893467E-02 3.10653528062E-02 3.15573476950E-02 3.20569864375E-02 3.25643829836E-02 3.30796528245E-02 3.36029130079E-02 3.41342821537E-02 3.46738804695E-02 3.52218297656E-02 3.57782534710E-02 3.63432766481E-02 3.69170260081E-02 3.74996299259E-02 3.80912184557E-02 3.86919233447E-02 3.93018780490E-02 3.99212177475E-02 4.05500793562E-02 4.11886015430E-02 4.18369247414E-02 4.24951911640E-02 4.31635448170E-02 4.38421315125E-02 4.45310988827E-02 4.52305963918E-02 4.59407753493E-02 4.66617889217E-02 4.73937921449E-02 4.81369419354E-02 4.88913971018E-02 4.96573183553E-02 5.04348683204E-02 5.12242115447E-02 5.20255145085E-02 5.28389456336E-02 5.36646752923E-02 5.45028758147E-02 5.53537214965E-02 5.62173886057E-02 5.70940553890E-02 5.79839020769E-02 5.88871108889E-02 5.98038660372E-02 6.07343537308E-02 6.16787621771E-02 6.26372815846E-02 6.36101041630E-02 6.45974241238E-02 6.55994376789E-02 6.66163430391E-02 6.76483404109E-02 6.86956319924E-02 6.97584219687E-02 7.08369165051E-02 7.19313237398E-02 7.30418537756E-02 7.41687186694E-02 7.53121324212E-02 7.64723109613E-02 7.76494721360E-02 7.88438356922E-02 8.00556232600E-02 8.12850583338E-02 8.25323662521E-02 8.37977741746E-02 8.50815110591E-02 8.63838076344E-02 8.77048963735E-02 8.90450114631E-02 9.04043887719E-02 9.17832658166E-02 9.31818817252E-02 9.46004771992E-02 9.60392944718E-02 9.74985772651E-02 9.89785707442E-02 1.00479521468E-01 1.02001677340E-01 1.03545287550E-01 1.05110602523E-01 1.06697873856E-01 1.08307354255E-01 1.09939297470E-01 1.11593958225E-01 1.13271592148E-01 1.14972455692E-01 1.16696806056E-01 1.18444901104E-01 1.20216999276E-01 1.22013359499E-01 1.23834241091E-01 1.25679903661E-01 1.27550607013E-01 1.29446611028E-01 1.31368175562E-01 1.33315560327E-01 1.35289024766E-01 1.37288827936E-01 1.39315228368E-01 1.41368483942E-01 1.43448851736E-01 1.45556587890E-01 1.47691947448E-01 1.49855184205E-01 1.52046550544E-01 1.54266297268E-01 1.56514673426E-01 1.58791926134E-01 1.61098300388E-01 1.63434038871E-01 1.65799381758E-01 1.68194566505E-01 1.70619827645E-01 1.73075396560E-01 1.75561501263E-01 1.78078366161E-01 1.80626211817E-01 1.83205254703E-01 1.85815706944E-01 1.88457776056E-01 1.91131664677E-01 1.93837570287E-01 1.96575684928E-01 1.99346194903E-01 2.02149280479E-01 2.04985115575E-01 2.07853867443E-01 2.10755696346E-01 2.13690755214E-01 2.16659189308E-01 2.19661135863E-01 2.22696723727E-01 2.25766072993E-01 2.28869294617E-01 2.32006490030E-01 2.35177750744E-01 2.38383157942E-01 2.41622782065E-01 2.44896682390E-01 2.48204906593E-01 2.51547490307E-01 2.54924456675E-01 2.58335815887E-01 2.61781564712E-01 2.65261686021E-01 2.68776148300E-01 2.72324905157E-01 2.75907894815E-01 2.79525039609E-01 2.83176245456E-01 2.86861401336E-01 2.90580378757E-01 2.94333031205E-01 2.98119193606E-01 3.01938681762E-01 3.05791291791E-01 3.09676799561E-01 3.13594960112E-01 3.17545507079E-01 3.21528152109E-01 3.25542584269E-01 3.29588469459E-01 3.33665449812E-01 3.37773143100E-01 3.41911142132E-01 3.46079014155E-01 3.50276300253E-01 3.54502514745E-01 3.58757144588E-01 3.63039648776E-01 3.67349457752E-01 3.71685972812E-01 3.76048565523E-01 3.80436577147E-01 3.84849318066E-01 3.89286067221E-01 3.93746071563E-01 3.98228545508E-01 4.02732670411E-01 4.07257594054E-01 4.11802430145E-01 4.16366257841E-01 4.20948121285E-01 4.25547029167E-01 4.30161954305E-01 4.34791833255E-01 4.39435565943E-01 4.44092015331E-01 4.48760007106E-01 4.53438329410E-01 4.58125732604E-01 4.62820929063E-01 4.67522593019E-01 4.72229360442E-01 4.76939828972E-01 4.81652557887E-01 4.86366068136E-01 4.91078842414E-01 4.95789325297E-01 5.00495923437E-01 5.05197005820E-01 5.09890904081E-01 5.14575912895E-01 5.19250290438E-01 5.23912258916E-01 5.28560005175E-01 5.33191681395E-01 5.37805405856E-01 5.42399263803E-01 5.46971308392E-01 5.51519561730E-01 5.56042016014E-01 5.60536634766E-01 5.65001354167E-01 5.69434084501E-01 5.73832711701E-01 5.78195099009E-01 5.82519088746E-01 5.86802504195E-01 5.91043151609E-01 5.95238822327E-01 5.99387295020E-01 6.03486338054E-01 6.07533711985E-01 6.11527172165E-01 6.15464471490E-01 6.19343363263E-01 6.23161604190E-01 6.26916957496E-01 6.30607196170E-01 6.34230106338E-01 6.37783490749E-01 6.41265172386E-01 6.44672998197E-01 6.48004842930E-01 6.51258613088E-01 6.54432250982E-01 6.57523738879E-01 6.60531103252E-01 6.63452419103E-01 6.66285814371E-01 6.69029474400E-01 6.71681646467E-01 6.74240644355E-01 6.76704852955E-01 6.79072732890E-01 6.81342825145E-01 6.83513755675E-01 6.85584239998E-01 6.87553087725E-01 6.89419207028E-01 6.91181609023E-01 6.92839412026E-01 6.94391845687E-01 6.95838254944E-01 6.97178103795E-01 6.98410978850E-01 6.99536592620E-01 7.00554786532E-01 7.01465533621E-01 7.02268940863E-01 7.02965251125E-01 7.03554844672E-01 7.04038240212E-01 7.04416095422E-01 7.04689206919E-01 7.04858509624E-01 7.04925075487E-01 7.04890111505E-01 7.04754957007E-01 7.04521080138E-01 7.04190073506E-01 7.03763648933E-01 7.03243631262E-01 7.02631951173E-01 7.01930636953E-01 7.01141805168E-01 7.00267650195E-01 6.99310432563E-01 6.98272466050E-01 6.97156103506E-01 6.95963721344E-01 6.94697702669E-01 6.93360419013E-01 6.91954210632E-01 6.90481365348E-01 6.88944095916E-01 6.87344515885E-01 6.85684613968E-01 6.83966226893E-01 6.82191010761E-01 6.80360410921E-01 6.78475630377E-01 6.76537596780E-01 6.74546928041E-01 6.72503896621E-01 6.70408392593E-01 6.68259885531E-01 6.66057385362E-01 6.63799402282E-01 6.61484387170E-01 6.59112340999E-01 6.56683711667E-01 6.54198962317E-01 6.51658571155E-01 6.49063031254E-01 6.46412850356E-01 6.43708550673E-01 6.40950668680E-01 6.38139754908E-01 6.35276373732E-01 6.32361103152E-01 6.29394534581E-01 6.26377272620E-01 6.23309934834E-01 6.20193151530E-01 6.17027565524E-01 6.13813831913E-01 6.10552617843E-01 6.07244602272E-01 6.03890475739E-01 6.00490940122E-01 5.97046708402E-01 5.93558504423E-01 5.90027062647E-01 5.86453127918E-01 5.82837455213E-01 5.79180809400E-01 5.75483964993E-01 5.71747705906E-01 5.67972825204E-01 5.64160124859E-01 5.60310415502E-01 5.56424516168E-01 5.52503254054E-01 5.48547464266E-01 5.44557989567E-01 5.40535680126E-01 5.36481393269E-01 5.32395993221E-01 5.28280350857E-01 5.24135343446E-01 5.19961854396E-01 5.15760772998E-01 5.11532994168E-01 5.07279418195E-01 5.03000950472E-01 4.98698501246E-01 4.94372985353E-01 4.90025321954E-01 4.85656434275E-01 4.81267249339E-01 4.76858697703E-01 4.72431713186E-01 4.67987232606E-01 4.63526195499E-01 4.59049543858E-01 4.54558221848E-01 4.50053175536E-01 4.45535352610E-01 4.41005702098E-01 4.36465174088E-01 4.31914719440E-01 4.27355289501E-01 4.22787835817E-01 4.18213309840E-01 4.13632662633E-01 4.09046844579E-01 4.04456805077E-01 3.99863492246E-01 3.95267852621E-01 3.90670830845E-01 3.86073369366E-01 3.81476408125E-01 3.76880884244E-01 3.72287731714E-01 3.67697881074E-01 3.63112259101E-01 3.58531788481E-01 3.53957387495E-01 3.49389969691E-01 3.44830443557E-01 3.40279712202E-01 3.35738673018E-01 3.31208217360E-01 3.26689230210E-01 3.22182589847E-01 3.17689167519E-01 3.13209827104E-01 3.08745424785E-01 3.04296808713E-01 2.99864818677E-01 2.95450285769E-01 2.91054032059E-01 2.86676870260E-01 2.82319603401E-01 2.77983024499E-01 2.73667916235E-01 2.69375050631E-01 2.65105188726E-01 2.60859080262E-01 2.56637463366E-01 2.52441064239E-01 2.48270596850E-01 2.44126762627E-01 2.40010250165E-01 2.35921734923E-01 2.31861878940E-01 2.27831330548E-01 2.23830724093E-01 2.19860679664E-01 2.15921802826E-01 2.12014684359E-01 2.08139900010E-01 2.04298010242E-01 2.00489560002E-01 1.96715078491E-01 1.92975078942E-01 1.89270058408E-01 1.85600497563E-01 1.81966860504E-01 1.78369594572E-01 1.74809130176E-01 1.71285880629E-01 1.67800241999E-01 1.64352592965E-01 1.60943294683E-01 1.57572690675E-01 1.54241106712E-01 1.50948850726E-01 1.47696212719E-01 1.44483464699E-01 1.41310860612E-01 1.38178636302E-01 1.35087009473E-01 1.32036179668E-01 1.29026328264E-01 1.26057618470E-01 1.23130195351E-01 1.20244185856E-01 1.17399698859E-01 1.14596825224E-01 1.11835637866E-01 1.09116191842E-01 1.06438524445E-01 1.03802655315E-01 1.01208586560E-01 9.86563028941E-02 9.61457717882E-02 9.36769436289E-02 9.12497518947E-02 8.88641133434E-02 8.65199282110E-02 8.42170804241E-02 8.19554378232E-02 7.97348523985E-02 7.75551605362E-02 7.54161832777E-02 7.33177265876E-02 7.12595816346E-02 6.92415250808E-02 6.72633193826E-02 6.53247131003E-02 6.34254412173E-02 6.15652254686E-02 5.97437746778E-02 5.79607851017E-02 5.62159407839E-02 5.45089139144E-02 5.28393651978E-02 5.12069442261E-02 4.96112898596E-02 4.80520306121E-02 4.65287850415E-02 4.50411621460E-02 4.35887617630E-02 4.21711749735E-02 4.07879845083E-02 3.94387651582E-02 3.81230841858E-02 3.68405017391E-02 3.55905712671E-02 3.43728399356E-02 3.31868490438E-02 3.20321344403E-02 3.09082269392E-02 2.98146527343E-02 2.87509338125E-02 2.77165883648E-02 2.67111311945E-02 2.57340741233E-02 2.47849263929E-02 2.38631950640E-02 2.29683854097E-02 2.21000013053E-02 2.12575456126E-02 2.04405205581E-02 1.96484281064E-02 1.88807703265E-02 1.81370497517E-02 1.74167697327E-02 1.67194347829E-02 1.60445509168E-02 1.53916259794E-02 1.47601699686E-02 1.41496953482E-02 1.35597173523E-02 1.29897542810E-02 1.24393277866E-02 1.19079631508E-02 1.13951895514E-02 1.09005403201E-02 1.04235531902E-02 9.96377053410E-03 9.52073959025E-03 9.09401268072E-03 8.68314741767E-03 8.28770689977E-03 7.90725989808E-03 7.54138103147E-03 7.18965093155E-03 6.85165639717E-03 6.52699053846E-03 6.21525291045E-03 5.91604963640E-03 5.62899352080E-03 5.35370415230E-03 5.08980799647E-03 4.83693847866E-03 4.59473605706E-03 4.36284828607E-03 4.14092987015E-03 3.92864270836E-03 3.72565592978E-03 3.53164591986E-03 3.34629633816E-03 3.16929812744E-03 3.00034951450E-03 2.83915600293E-03 2.68543035796E-03 2.53889258381E-03 2.39926989365E-03 2.26629667243E-03 2.13971443303E-03 2.01927176569E-03 1.90472428131E-03 1.79583454868E-03 1.69237202601E-03 1.59411298699E-03 1.50084044176E-03 1.41234405292E-03 1.32842004702E-03 1.24887112167E-03 1.17350634862E-03 1.10214107321E-03 1.03459681025E-03 9.70701136599E-04 9.10287580973E-04 8.53195510964E-04 7.99270017709E-04 7.48361798385E-04 7.00327036808E-04 6.55027282371E-04 6.12329327562E-04 5.72105084298E-04 5.34231459284E-04 4.98590228500E-04 4.65067911632E-04 4.33555645683E-04 4.03949058587E-04 3.76148142898E-04 3.50057754607E-04 3.25592455486E-04 3.02664594756E-04 2.81189796843E-04 2.61087526130E-04 2.42280958145E-04 2.24696852781E-04 2.08265429530E-04 1.92920244824E-04 1.78598071538E-04 1.65238780750E-04 1.52785225811E-04 1.41183128783E-04 1.30380969301E-04 1.20329875914E-04 1.10983519929E-04 1.02298011815E-04 9.42318001765E-05 8.67455733439E-05 7.98021635780E-05 7.33664539220E-05 6.74052876995E-05 6.18873806684E-05 5.67832358298E-05 5.20650608874E-05 4.77066883515E-05 4.36834982725E-05 3.99723435912E-05 3.65514780847E-05 3.34004868866E-05 3.05002195561E-05 2.78327256675E-05 2.53811928917E-05 2.31298875347E-05 2.10640975028E-05 1.91700776563E-05 1.74349975176E-05 1.58468912961E-05 1.43946101941E-05 1.30677769570E-05 1.18567426326E-05 1.07525455055E-05 9.74687217560E-06 8.83202075018E-06 8.00086612620E-06 7.24682734010E-06 6.56383697038E-06 5.94036679653E-06 5.37169638876E-06 4.85343778216E-06 4.38151554439E-06 3.95214777250E-06 3.56182799426E-06 3.20730794862E-06 2.88558121958E-06 2.59386769728E-06 2.32959883973E-06 2.09040370858E-06 1.87409575205E-06 1.67866030812E-06 1.50224280123E-06 1.34313760572E-06 1.19977754942E-06 1.07072403126E-06 9.54657726769E-07 8.50369855926E-07 7.56753988161E-07 6.72798359788E-07 5.97578679629E-07 5.30251399166E-07 4.70047424137E-07 4.16266245075E-07 3.68270464956E-07 3.25480702756E-07 2.87370852405E-07 2.53463677310E-07 2.23326721321E-07 1.96568517717E-07 1.72835078507E-07 1.51806647056E-07 1.33194697741E-07 1.16739167078E-07 1.02205901434E-07 8.93843071544E-08 7.80851895993E-08 6.81387682733E-08 5.93928558693E-08 5.17111897050E-08 4.49719046439E-08 3.90661372083E-08 3.38967511733E-08 2.93771755052E-08 2.54303460532E-08 2.19877429349E-08 1.89885160613E-08 1.63786917351E-08 1.41104537224E-08 1.21414926400E-08 1.04344179266E-08 8.95622706613E-09 7.67782711506E-09 6.57360394645E-09 5.62103496485E-09 4.80034136906E-09 4.09417634296E-09 3.48734583980E-09 2.96655889274E-09 2.52020463498E-09 2.13815344664E-09 1.81157986395E-09 1.53280508935E-09 1.29515713014E-09 1.09284676834E-09 9.20857726630E-10 7.74849545448E-10 6.51071824188E-10 5.46288607313E-10 4.57711813026E-10 3.82942709735E-10 3.19920544000E-10 2.66877513639E-10 2.22299361870E-10 1.84890943217E-10 1.53546179977E-10 1.27321889872E-10 1.05415021496E-10 8.71428848377E-11 7.19260098896E-11 5.92733075804E-11 4.87692443473E-11 4.00627749649E-11 3.28578080902E-11 2.69050056908E-11 2.19947413604E-11 1.79510637887E-11 1.46265305562E-11 1.18977942221E-11 9.66183755709E-12 7.83276794205E-12 6.33909258273E-12 5.12140644140E-12 4.13043380130E-12 3.32537229761E-12 2.67249518591E-12 2.14397368704E-12 1.71688654412E-12 1.37238854256E-12 1.09501375640E-12 8.72092766914E-13 6.93266115216E-13 5.50078857739E-13 4.35643342332E-13 3.44359258731E-13 2.71681680623E-13 2.13929242710E-13 1.68125816542E-13 1.31870090927E-13 1.03228350681E-13 8.06465025480E-14 6.28780378278E-14 4.89251638031E-14 3.79907944873E-14 2.94394777460E-14 2.27656610644E-14 1.75679712600E-14 1.35284121562E-14 1.03955754135E-14 7.97111916190E-15 6.09890176789E-15 4.65626824356E-15 3.54707807953E-15 2.69613872780E-15 2.04477117931E-15 1.54728527467E-15 1.16818441094E-15 8.79953725270E-16 6.61313958132E-16 4.95846122233E-16 3.70910745038E-16 2.76800576186E-16 2.06077890770E-16 1.53057401311E-16 1.13403749880E-16 8.38189459520E-17 6.18002399073E-17 4.54530186704E-17 3.33465766094E-17 2.44032131650E-17 1.78131701258E-17 1.29695527981E-17 9.41866693364E-18 6.82221695872E-18 4.92860697830E-18 3.55120934053E-18 2.55195237521E-18 1.82895813705E-18 1.30725557791E-18 9.31822806662E-19 6.62388433895E-19 4.69557866463E-19 3.31934811894E-19 2.33988240583E-19 1.64476168645E-19 1.15284186588E-19 8.05720325902E-20 5.61483052614E-20 3.90136504156E-20 2.70279991179E-20 1.86688799606E-20 1.28563975643E-20 8.82686549433E-21 6.04184173390E-21 4.12284638724E-21 2.80465342417E-21 1.90197441703E-21 1.28576811974E-21 8.66447305255E-22 5.82012208863E-22 3.89691830208E-22 2.60074943534E-22 1.73002500157E-22 1.14702123582E-22 7.57956385346E-23 4.99182124945E-23 3.27645469322E-23 2.14322529582E-23 1.39713410867E-23 9.07617726068E-24 5.87557463581E-24 3.79025153244E-24 2.43637271642E-24 1.56050454988E-24 9.95908579182E-25 6.33278051506E-25 4.01215065317E-25 2.53253271273E-25 1.59263051181E-25 9.97801453689E-26 6.22772257400E-26 3.87219478099E-26 2.39836139832E-26 1.47974923046E-26 9.09419271613E-27 5.56710066433E-27 3.39444779887E-27 2.56692889984E-07 2.60833446458E-07 2.65040798894E-07 2.69316025087E-07 2.73660220229E-07 2.78074497191E-07 2.82559986810E-07 2.87117838179E-07 2.91749218941E-07 2.96455315588E-07 3.01237333769E-07 3.06096498597E-07 3.11034054961E-07 3.16051267851E-07 3.21149422682E-07 3.26329825619E-07 3.31593803917E-07 3.36942706261E-07 3.42377903113E-07 3.47900787060E-07 3.53512773180E-07 3.59215299394E-07 3.65009826846E-07 3.70897840272E-07 3.76880848385E-07 3.82960384259E-07 3.89138005726E-07 3.95415295774E-07 4.01793862958E-07 4.08275341808E-07 4.14861393250E-07 4.21553705037E-07 4.28353992180E-07 4.35263997387E-07 4.42285491513E-07 4.49420274018E-07 4.56670173424E-07 4.64037047788E-07 4.71522785182E-07 4.79129304173E-07 4.86858554322E-07 4.94712516683E-07 5.02693204311E-07 5.10802662782E-07 5.19042970719E-07 5.27416240326E-07 5.35924617932E-07 5.44570284542E-07 5.53355456402E-07 5.62282385563E-07 5.71353360467E-07 5.80570706531E-07 5.89936786750E-07 5.99454002302E-07 6.09124793168E-07 6.18951638758E-07 6.28937058553E-07 6.39083612752E-07 6.49393902929E-07 6.59870572708E-07 6.70516308440E-07 6.81333839897E-07 6.92325940975E-07 7.03495430409E-07 7.14845172498E-07 7.26378077846E-07 7.38097104109E-07 7.50005256759E-07 7.62105589861E-07 7.74401206856E-07 7.86895261366E-07 7.99590958004E-07 8.12491553201E-07 8.25600356049E-07 8.38920729150E-07 8.52456089488E-07 8.66209909309E-07 8.80185717017E-07 8.94387098086E-07 9.08817695982E-07 9.23481213111E-07 9.38381411766E-07 9.53522115108E-07 9.68907208145E-07 9.84540638742E-07 1.00042641864E-06 1.01656862449E-06 1.03297139890E-06 1.04963895153E-06 1.06657556016E-06 1.08378557179E-06 1.10127340379E-06 1.11904354501E-06 1.13710055698E-06 1.15544907506E-06 1.17409380963E-06 1.19303954736E-06 1.21229115240E-06 1.23185356767E-06 1.25173181610E-06 1.27193100198E-06 1.29245631227E-06 1.31331301790E-06 1.33450647522E-06 1.35604212728E-06 1.37792550536E-06 1.40016223030E-06 1.42275801403E-06 1.44571866101E-06 1.46905006977E-06 1.49275823439E-06 1.51684924613E-06 1.54132929495E-06 1.56620467112E-06 1.59148176690E-06 1.61716707817E-06 1.64326720610E-06 1.66978885892E-06 1.69673885361E-06 1.72412411770E-06 1.75195169107E-06 1.78022872777E-06 1.80896249791E-06 1.83816038953E-06 1.86782991052E-06 1.89797869059E-06 1.92861448325E-06 1.95974516785E-06 1.99137875160E-06 2.02352337168E-06 2.05618729737E-06 2.08937893220E-06 2.12310681612E-06 2.15737962778E-06 2.19220618674E-06 2.22759545584E-06 2.26355654346E-06 2.30009870600E-06 2.33723135020E-06 2.37496403568E-06 2.41330647740E-06 2.45226854822E-06 2.49186028148E-06 2.53209187363E-06 2.57297368691E-06 2.61451625203E-06 2.65673027100E-06 2.69962661989E-06 2.74321635167E-06 2.78751069918E-06 2.83252107800E-06 2.87825908950E-06 2.92473652391E-06 2.97196536334E-06 3.01995778502E-06 3.06872616446E-06 3.11828307872E-06 3.16864130971E-06 3.21981384760E-06 3.27181389420E-06 3.32465486646E-06 3.37835040003E-06 3.43291435283E-06 3.48836080874E-06 3.54470408130E-06 3.60195871752E-06 3.66013950172E-06 3.71926145942E-06 3.77933986136E-06 3.84039022753E-06 3.90242833129E-06 3.96547020353E-06 4.02953213698E-06 4.09463069049E-06 4.16078269345E-06 4.22800525026E-06 4.29631574491E-06 4.36573184555E-06 4.43627150925E-06 4.50795298680E-06 4.58079482750E-06 4.65481588419E-06 4.73003531827E-06 4.80647260478E-06 4.88414753766E-06 4.96308023503E-06 5.04329114457E-06 5.12480104901E-06 5.20763107171E-06 5.29180268230E-06 5.37733770250E-06 5.46425831193E-06 5.55258705413E-06 5.64234684259E-06 5.73356096692E-06 5.82625309918E-06 5.92044730021E-06 6.01616802617E-06 6.11344013512E-06 6.21228889379E-06 6.31273998436E-06 6.41481951147E-06 6.51855400927E-06 6.62397044866E-06 6.73109624457E-06 6.83995926346E-06 6.95058783087E-06 7.06301073917E-06 7.17725725541E-06 7.29335712926E-06 7.41134060123E-06 7.53123841085E-06 7.65308180515E-06 7.77690254720E-06 7.90273292482E-06 8.03060575948E-06 8.16055441527E-06 8.29261280815E-06 8.42681541524E-06 8.56319728438E-06 8.70179404374E-06 8.84264191178E-06 8.98577770715E-06 9.13123885900E-06 9.27906341730E-06 9.42929006346E-06 9.58195812103E-06 9.73710756672E-06 9.89477904149E-06 1.00550138619E-05 1.02178540318E-05 1.03833422538E-05 1.05515219416E-05 1.07224372318E-05 1.08961329966E-05 1.10726548563E-05 1.12520491923E-05 1.14343631599E-05 1.16196447018E-05 1.18079425620E-05 1.19993062989E-05 1.21937862999E-05 1.23914337958E-05 1.25923008750E-05 1.27964404985E-05 1.30039065152E-05 1.32147536773E-05 1.34290376556E-05 1.36468150561E-05 1.38681434357E-05 1.40930813191E-05 1.43216882157E-05 1.45540246368E-05 1.47901521127E-05 1.50301332114E-05 1.52740315559E-05 1.55219118432E-05 1.57738398632E-05 1.60298825178E-05 1.62901078404E-05 1.65545850160E-05 1.68233844015E-05 1.70965775464E-05 1.73742372141E-05 1.76564374030E-05 1.79432533689E-05 1.82347616469E-05 1.85310400747E-05 1.88321678153E-05 1.91382253808E-05 1.94492946568E-05 1.97654589266E-05 2.00868028964E-05 2.04134127211E-05 2.07453760296E-05 2.10827819523E-05 2.14257211474E-05 2.17742858288E-05 2.21285697943E-05 2.24886684540E-05 2.28546788599E-05 2.32266997355E-05 2.36048315061E-05 2.39891763300E-05 2.43798381303E-05 2.47769226266E-05 2.51805373685E-05 2.55907917689E-05 2.60077971382E-05 2.64316667190E-05 2.68625157225E-05 2.73004613638E-05 2.77456228998E-05 2.81981216668E-05 2.86580811187E-05 2.91256268671E-05 2.96008867208E-05 3.00839907272E-05 3.05750712143E-05 3.10742628330E-05 3.15817026008E-05 3.20975299467E-05 3.26218867560E-05 3.31549174173E-05 3.36967688693E-05 3.42475906496E-05 3.48075349435E-05 3.53767566350E-05 3.59554133577E-05 3.65436655477E-05 3.71416764969E-05 3.77496124081E-05 3.83676424508E-05 3.89959388183E-05 3.96346767860E-05 4.02840347713E-05 4.09441943942E-05 4.16153405396E-05 4.22976614209E-05 4.29913486448E-05 4.36965972778E-05 4.44136059139E-05 4.51425767440E-05 4.58837156265E-05 4.66372321597E-05 4.74033397559E-05 4.81822557167E-05 4.89742013104E-05 4.97794018511E-05 5.05980867793E-05 5.14304897444E-05 5.22768486888E-05 5.31374059350E-05 5.40124082730E-05 5.49021070507E-05 5.58067582665E-05 5.67266226633E-05 5.76619658252E-05 5.86130582759E-05 5.95801755800E-05 6.05635984463E-05 6.15636128329E-05 6.25805100562E-05 6.36145869006E-05 6.46661457322E-05 6.57354946145E-05 6.68229474269E-05 6.79288239858E-05 6.90534501689E-05 7.01971580423E-05 7.13602859903E-05 7.25431788487E-05 7.37461880410E-05 7.49696717181E-05 7.62139949006E-05 7.74795296257E-05 7.87666550967E-05 8.00757578361E-05 8.14072318431E-05 8.27614787540E-05 8.41389080075E-05 8.55399370129E-05 8.69649913231E-05 8.84145048120E-05 8.98889198556E-05 9.13886875177E-05 9.29142677410E-05 9.44661295413E-05 9.60447512084E-05 9.76506205104E-05 9.92842349038E-05 1.00946101749E-04 1.02636738531E-04 1.04356673085E-04 1.06106443828E-04 1.07886599998E-04 1.09697701897E-04 1.11540321139E-04 1.13415040910E-04 1.15322456225E-04 1.17263174203E-04 1.19237814341E-04 1.21247008797E-04 1.23291402681E-04 1.25371654351E-04 1.27488435724E-04 1.29642432583E-04 1.31834344905E-04 1.34064887187E-04 1.36334788784E-04 1.38644794262E-04 1.40995663749E-04 1.43388173302E-04 1.45823115287E-04 1.48301298758E-04 1.50823549856E-04 1.53390712218E-04 1.56003647386E-04 1.58663235242E-04 1.61370374446E-04 1.64125982883E-04 1.66930998131E-04 1.69786377933E-04 1.72693100686E-04 1.75652165944E-04 1.78664594930E-04 1.81731431068E-04 1.84853740521E-04 1.88032612754E-04 1.91269161105E-04 1.94564523369E-04 1.97919862410E-04 2.01336366776E-04 2.04815251340E-04 2.08357757952E-04 2.11965156116E-04 2.15638743680E-04 2.19379847547E-04 2.23189824404E-04 2.27070061476E-04 2.31021977294E-04 2.35047022488E-04 2.39146680607E-04 2.43322468948E-04 2.47575939423E-04 2.51908679441E-04 2.56322312821E-04 2.60818500721E-04 2.65398942605E-04 2.70065377228E-04 2.74819583652E-04 2.79663382294E-04 2.84598635996E-04 2.89627251129E-04 2.94751178734E-04 2.99972415685E-04 3.05293005890E-04 3.10715041530E-04 3.16240664326E-04 3.21872066843E-04 3.27611493842E-04 3.33461243652E-04 3.39423669599E-04 3.45501181465E-04 3.51696246993E-04 3.58011393431E-04 3.64449209132E-04 3.71012345183E-04 3.77703517093E-04 3.84525506527E-04 3.91481163091E-04 3.98573406161E-04 4.05805226778E-04 4.13179689585E-04 4.20699934830E-04 4.28369180421E-04 4.36190724043E-04 4.44167945337E-04 4.52304308140E-04 4.60603362794E-04 4.69068748519E-04 4.77704195859E-04 4.86513529191E-04 4.95500669322E-04 5.04669636145E-04 5.14024551387E-04 5.23569641429E-04 5.33309240210E-04 5.43247792224E-04 5.53389855590E-04 5.63740105226E-04 5.74303336111E-04 5.85084466642E-04 5.96088542093E-04 6.07320738171E-04 6.18786364684E-04 6.30490869308E-04 6.42439841476E-04 6.54639016372E-04 6.67094279052E-04 6.79811668677E-04 6.92797382880E-04 7.06057782257E-04 7.19599394995E-04 7.33428921633E-04 7.47553239966E-04 7.61979410098E-04 7.76714679635E-04 7.91766489045E-04 8.07142477166E-04 8.22850486885E-04 8.38898570983E-04 8.55294998150E-04 8.72048259188E-04 8.89167073386E-04 9.06660395100E-04 9.24537420510E-04 9.42807594597E-04 9.61480618312E-04 9.80566455970E-04 1.00007534286E-03 1.02001779306E-03 1.04040460754E-03 1.06124688245E-03 1.08255601768E-03 1.10434372567E-03 1.12662204046E-03 1.14940332709E-03 1.17270029117E-03 1.19652598881E-03 1.22089383680E-03 1.24581762315E-03 1.27131151788E-03 1.29739008419E-03 1.32406828989E-03 1.35136151923E-03 1.37928558510E-03 1.40785674148E-03 1.43709169643E-03 1.46700762528E-03 1.49762218436E-03 1.52895352507E-03 1.56102030836E-03 1.59384171970E-03 1.62743748440E-03 1.66182788347E-03 1.69703376989E-03 1.73307658542E-03 1.76997837785E-03 1.80776181880E-03 1.84645022199E-03 1.88606756216E-03 1.92663849441E-03 1.96818837424E-03 2.01074327805E-03 2.05433002439E-03 2.09897619571E-03 2.14471016078E-03 2.19156109788E-03 2.23955901845E-03 2.28873479169E-03 2.33912016965E-03 2.39074781323E-03 2.44365131883E-03 2.49786524582E-03 2.55342514484E-03 2.61036758686E-03 2.66873019315E-03 2.72855166608E-03 2.78987182081E-03 2.85273161799E-03 2.91717319724E-03 2.98323991179E-03 3.05097636395E-03 3.12042844177E-03 3.19164335660E-03 3.26466968182E-03 3.33955739271E-03 3.41635790738E-03 3.49512412891E-03 3.57591048875E-03 3.65877299129E-03 3.74376925971E-03 3.83095858317E-03 3.92040196535E-03 4.01216217427E-03 4.10630379368E-03 4.20289327577E-03 4.30199899541E-03 4.40369130594E-03 4.50804259654E-03 4.61512735111E-03 4.72502220895E-03 4.83780602698E-03 4.95355994384E-03 5.07236744564E-03 5.19431443363E-03 5.31948929370E-03 5.44798296779E-03 5.57988902730E-03 5.71530374848E-03 5.85432618991E-03 5.99705827207E-03 6.14360485911E-03 6.29407384280E-03 6.44857622880E-03 6.60722622518E-03 6.77014133344E-03 6.93744244184E-03 7.10925392129E-03 7.28570372382E-03 7.46692348360E-03 7.65304862067E-03 7.84421844736E-03 8.04057627758E-03 8.24226953889E-03 8.44944988750E-03 8.66227332628E-03 8.88090032582E-03 9.10549594855E-03 9.33622997607E-03 9.57327703973E-03 9.81681675449E-03 1.00670338562E-02 1.03241183423E-02 1.05882656159E-02 1.08596766338E-02 1.11385580577E-02 1.14251224097E-02 1.17195882306E-02 1.20221802434E-02 1.23331295197E-02 1.26526736504E-02 1.29810569205E-02 1.33185304883E-02 1.36653525679E-02 1.40217886172E-02 1.43881115295E-02 1.47646018294E-02 1.51515478734E-02 1.55492460555E-02 1.59580010163E-02 1.63781258577E-02 1.68099423622E-02 1.72537812163E-02 1.77099822394E-02 1.81788946179E-02 1.86608771427E-02 1.91562984538E-02 1.96655372881E-02 2.01889827335E-02 2.07270344873E-02 2.12801031205E-02 2.18486103467E-02 2.24329892962E-02 2.30336847960E-02 2.36511536545E-02 2.42858649515E-02 2.49383003336E-02 2.56089543149E-02 2.62983345831E-02 2.70069623106E-02 2.77353724712E-02 2.84841141614E-02 2.92537509280E-02 3.00448610994E-02 3.08580381236E-02 3.16938909101E-02 3.25530441767E-02 3.34361388027E-02 3.43438321848E-02 3.52767985993E-02 3.62357295682E-02 3.72213342300E-02 3.82343397147E-02 3.92754915226E-02 4.03455539081E-02 4.14453102663E-02 4.25755635237E-02 4.37371365319E-02 4.49308724649E-02 4.61576352190E-02 4.74183098154E-02 4.87138028048E-02 5.00450426745E-02 5.14129802566E-02 5.28185891380E-02 5.42628660704E-02 5.57468313819E-02 5.72715293878E-02 5.88380288009E-02 6.04474231416E-02 6.21008311455E-02 6.37993971695E-02 6.55442915954E-02 6.73367112300E-02 6.91778797009E-02 7.10690478483E-02 7.30114941109E-02 7.50065249065E-02 7.70554750043E-02 7.91597078907E-02 8.13206161257E-02 8.35396216901E-02 8.58181763217E-02 8.81577618400E-02 9.05598904588E-02 9.30261050841E-02 9.55579795975E-02 9.81571191242E-02 1.00825160282E-01 1.03563771412E-01 1.06374652792E-01 1.09259536823E-01 1.12220188199E-01 1.15258404045E-01 1.18376014038E-01 1.21574880492E-01 1.24856898416E-01 1.28223995546E-01 1.31678132336E-01 1.35221301921E-01 1.38855530037E-01 1.42582874908E-01 1.46405427090E-01 1.50325309269E-01 1.54344676021E-01 1.58465713517E-01 1.62690639185E-01 1.67021701314E-01 1.71461178609E-01 1.76011379690E-01 1.80674642522E-01 1.85453333798E-01 1.90349848243E-01 1.95366607864E-01 2.00506061123E-01 2.05770682034E-01 2.11162969198E-01 2.16685444745E-01 2.22340653206E-01 2.28131160295E-01 2.34059551608E-01 2.40128431232E-01 2.46340420259E-01 2.52698155207E-01 2.59204286344E-01 2.65861475908E-01 2.72672396221E-01 2.79639727704E-01 2.86766156773E-01 2.94054373627E-01 3.01507069921E-01 3.09126936318E-01 3.16916659919E-01 3.24878921575E-01 3.33016393068E-01 3.41331734164E-01 3.49827589536E-01 3.58506585553E-01 3.67371326935E-01 3.76424393269E-01 3.85668335389E-01 3.95105671612E-01 4.04738883832E-01 4.14570413475E-01 4.24602657307E-01 4.34837963094E-01 4.45278625125E-01 4.55926879580E-01 4.66784899762E-01 4.77854791173E-01 4.89138586458E-01 5.00638240199E-01 5.12355623565E-01 5.24292518831E-01 5.36450613753E-01 5.48831495812E-01 5.61436646324E-01 5.74267434428E-01 5.87325110945E-01 6.00610802124E-01 6.14125503276E-01 6.27870072293E-01 6.41845223079E-01 6.56051518884E-01 6.70489365547E-01 6.85159004675E-01 7.00060506750E-01 7.15193764173E-01 7.30558484280E-01 7.46154182308E-01 7.61980174345E-01 7.78035570282E-01 7.94319266754E-01 8.10829940122E-01 8.27566039475E-01 8.44525779701E-01 8.61707134621E-01 8.79107830221E-01 8.96725337985E-01 9.14556868373E-01 9.32599364439E-01 9.50849495630E-01 9.69303651786E-01 9.87957937355E-01 1.00680816587E+00 1.02584985466E+00 1.04507821996E+00 1.06448817220E+00 1.08407431178E+00 1.10383092518E+00 1.12375198150E+00 1.14383112941E+00 1.16406169462E+00 1.18443667786E+00 1.20494875337E+00 1.22559026801E+00 1.24635324090E+00 1.26722936383E+00 1.28821000217E+00 1.30928619666E+00 1.33044866583E+00 1.35168780919E+00 1.37299371132E+00 1.39435614663E+00 1.41576458516E+00 1.43720819913E+00 1.45867587047E+00 1.48015619930E+00 1.50163751332E+00 1.52310787826E+00 1.54455510924E+00 1.56596678327E+00 1.58733025262E+00 1.60863265941E+00 1.62986095108E+00 1.65100189700E+00 1.67204210611E+00 1.69296804553E+00 1.71376606025E+00 1.73442239378E+00 1.75492320975E+00 1.77525461451E+00 1.79540268052E+00 1.81535347068E+00 1.83509306337E+00 1.85460757828E+00 1.87388320282E+00 1.89290621917E+00 1.91166303176E+00 1.93014019514E+00 1.94832444214E+00 1.96620271218E+00 1.98376217956E+00 2.00099028172E+00 2.01787474716E+00 2.03440362298E+00 2.05056530185E+00 2.06634854822E+00 2.08174252356E+00 2.09673681051E+00 2.11132143565E+00 2.12548689083E+00 2.13922415265E+00 2.15252470005E+00 2.16538052967E+00 2.17778416886E+00 2.18972868603E+00 2.20120769812E+00 2.21221537506E+00 2.22274644090E+00 2.23279617138E+00 2.24236038781E+00 2.25143544707E+00 2.26001822736E+00 2.26810610971E+00 2.27569695502E+00 2.28278907637E+00 2.28938120660E+00 2.29547246097E+00 2.30106229471E+00 2.30615045558E+00 2.31073693112E+00 2.31482189075E+00 2.31840562261E+00 2.32148846513E+00 2.32407073346E+00 2.32615264071E+00 2.32773421418E+00 2.32881520673E+00 2.32939500329E+00 2.32947252301E+00 2.32904611697E+00 2.32811346195E+00 2.32667145058E+00 2.32471607813E+00 2.32224232648E+00 2.31924404582E+00 2.31571383449E+00 2.31164291773E+00 2.30702102607E+00 2.30183627408E+00 2.29607817154E+00 2.28974768215E+00 2.28284913828E+00 2.27538729546E+00 2.26736732694E+00 2.25879481763E+00 2.24967575762E+00 2.24001653517E+00 2.22982392920E+00 2.21910510131E+00 2.20786758738E+00 2.19611928868E+00 2.18386846256E+00 2.17112371274E+00 2.15789397919E+00 2.14418852762E+00 2.13001693864E+00 2.11538909654E+00 2.10031517774E+00 2.08480563897E+00 2.06887120514E+00 2.05252285693E+00 2.03577181815E+00 2.01862954284E+00 2.00110770226E+00 1.98321817156E+00 1.96497301636E+00 1.94638447922E+00 1.92746496591E+00 1.90822703163E+00 1.88868336716E+00 1.86884678492E+00 1.84873020502E+00 1.82834664129E+00 1.80770918727E+00 1.78683100236E+00 1.76572529782E+00 1.74440532306E+00 1.72288435180E+00 1.70117566854E+00 1.67929255498E+00 1.65724827672E+00 1.63505607007E+00 1.61272912898E+00 1.59028059233E+00 1.56772353125E+00 1.54507093680E+00 1.52233570783E+00 1.49952705880E+00 1.47666128737E+00 1.45375094730E+00 1.43080845438E+00 1.40784607575E+00 1.38487591960E+00 1.36190992512E+00 1.33895985285E+00 1.31603721252E+00 1.29315344303E+00 1.27031971461E+00 1.24754698386E+00 1.22484598593E+00 1.20222722711E+00 1.17970097780E+00 1.15727726595E+00 1.13496587081E+00 1.11277631715E+00 1.09071786988E+00 1.06879952906E+00 1.04703002536E+00 1.02541781587E+00 1.00397108043E+00 9.82697718199E-01 9.61605344838E-01 9.40701289922E-01 9.19992594858E-01 8.99486011157E-01 8.79187999118E-01 8.59104726892E-01 8.39242069930E-01 8.19605610813E-01 8.00200639449E-01 7.81032153629E-01 7.62104859949E-01 7.43423175071E-01 7.24991227328E-01 7.06812858657E-01 6.88891626853E-01 6.71230808138E-01 6.53833400028E-01 6.36702124494E-01 6.19839431398E-01 6.03247502210E-01 5.86928253975E-01 5.70883343526E-01 5.55114171946E-01 5.39621889235E-01 5.24407399211E-01 5.09471364595E-01 4.94814212291E-01 4.80436138846E-01 4.66337116069E-01 4.52516896805E-01 4.38975020847E-01 4.25710820979E-01 4.12723429132E-01 4.00011782646E-01 3.87574630619E-01 3.75410540341E-01 3.63517903794E-01 3.51894944206E-01 3.40539722653E-01 3.29450144692E-01 3.18623967016E-01 3.08058804123E-01 2.97752134984E-01 2.87701309702E-01 2.77903556148E-01 2.68355986572E-01 2.59055604171E-01 2.49999309611E-01 2.41183907489E-01 2.32606112733E-01 2.24262556921E-01 2.16149794522E-01 2.08264309051E-01 2.00602519117E-01 1.93160784373E-01 1.85935411360E-01 1.78922659223E-01 1.72118745317E-01 1.65519850680E-01 1.59122125370E-01 1.52921693675E-01 1.46914659171E-01 1.41097109648E-01 1.35465121876E-01 1.30014766230E-01 1.24742111155E-01 1.19643227479E-01 1.14714192570E-01 1.09951094332E-01 1.05350035040E-01 1.00907135022E-01 9.66185361689E-02 9.24804052963E-02 8.84889373359E-02 8.46403583723E-02 8.09309285195E-02 7.73569446399E-02 7.39147429071E-02 7.06007012137E-02 6.74112414274E-02 6.43428314962E-02 6.13919874058E-02 5.85552749919E-02 5.58293116095E-02 5.32107676640E-02 5.06963680043E-02 4.82828931844E-02 4.59671805951E-02 4.37461254690E-02 4.16166817646E-02 3.95758629307E-02 3.76207425571E-02 3.57484549142E-02 3.39561953855E-02 3.22412207985E-02 3.06008496560E-02 2.90324622731E-02 2.75335008241E-02 2.61014693025E-02 2.47339333985E-02 2.34285202994E-02 2.21829184137E-02 2.09948770268E-02 1.98622058889E-02 1.87827747411E-02 1.77545127821E-02 1.67754080806E-02 1.58435069351E-02 1.49569131872E-02 1.41137874892E-02 1.33123465317E-02 1.25508622329E-02 1.18276608936E-02 1.11411223207E-02 1.04896789220E-02 9.87181477602E-03 9.28606467876E-03 8.73101317006E-03 8.20529354299E-03 7.70758683784E-03 7.23662082359E-03 6.79116896890E-03 6.37004940484E-03 5.97212388145E-03 5.59629671998E-03 5.24151376273E-03 4.90676132232E-03 4.59106513184E-03 4.29348929765E-03 4.01313525622E-03 3.74914073639E-03 3.50067872834E-03 3.26695646055E-03 3.04721438584E-03 2.84072517754E-03 2.64679273680E-03 2.46475121195E-03 2.29396403074E-03 2.13382294621E-03 1.98374709698E-03 1.84318208252E-03 1.71159905403E-03 1.58849382147E-03 1.47338597721E-03 1.36581803667E-03 1.26535459646E-03 1.17158151019E-03 1.08410508236E-03 1.00255128050E-03 9.26564965737E-04 8.55809142097E-04 7.89964224430E-04 7.28727325253E-04 6.71811560451E-04 6.18945373889E-04 5.69871880924E-04 5.24348230770E-04 4.82144987654E-04 4.43045530671E-04 4.06845472214E-04 3.73352094832E-04 3.42383806375E-04 3.13769613204E-04 2.87348611299E-04 2.62969495007E-04 2.40490083218E-04 2.19776862690E-04 2.00704548261E-04 1.83155659659E-04 1.67020114608E-04 1.52194837926E-04 1.38583386276E-04 1.26095588261E-04 1.14647199498E-04 1.04159572338E-04 9.45593398650E-05 8.57781138224E-05 7.77521960865E-05 7.04223033260E-05 6.37333044666E-05 5.76339705846E-05 5.20767368503E-05 4.70174761416E-05 4.24152839468E-05 3.82322741773E-05 3.44333855135E-05 3.09861979068E-05 2.78607588660E-05 2.50294191579E-05 2.24666775571E-05 2.01490342859E-05 1.80548527864E-05 1.61642294776E-05 1.44588711541E-05 1.29219796877E-05 1.15381437059E-05 1.02932369214E-05 9.17432280195E-06 8.16956527180E-06 7.26814514773E-06 6.46018202068E-06 5.73666130178E-06 5.08936616126E-06 4.51081409746E-06 3.99419788216E-06 3.53333063771E-06 3.12259481047E-06 2.75689481404E-06 2.43161312617E-06 2.14256962938E-06 1.88598399714E-06 1.65844093526E-06 1.45685809657E-06 1.27845649592E-06 1.12073326066E-06 9.81436560354E-07 8.58542567031E-07 7.50234305515E-07 6.54882260694E-07 5.71026616043E-07 4.97361004648E-07 4.32717662268E-07 3.76053875293E-07 3.26439626408E-07 2.83046345106E-07 2.45137551561E-07 2.12065727976E-07 1.83247077673E-07 1.58163220082E-07 1.36355208255E-07 1.17417181917E-07 1.00990643255E-07 8.67593003365E-08 7.44444274457E-08 6.38006955317E-08 5.46124297135E-08 4.66902542117E-08 3.98680883247E-08 3.40004600735E-08 2.89601069425E-08 2.46358357524E-08 2.09306161152E-08 1.77598841687E-08 1.50500353566E-08 1.27370869399E-08 1.07654926933E-08 9.08709386722E-09 7.66019199600E-09 6.44873050804E-09 5.42157335460E-09 4.55187002981E-09 3.81649740934E-09 3.19556979955E-09 2.67200946613E-09 2.23117071073E-09 1.86051128912E-09 1.54930562282E-09 1.28839485180E-09 1.06996931431E-09 8.87379526254E-10 7.34972170260E-10 6.07947998691E-10 5.02238908657E-10 4.14401764308E-10 3.41526819015E-10 2.81158880493E-10 2.31229506913E-10 1.89998814721E-10 1.56005606632E-10 1.28024699279E-10 1.05030471004E-10 8.61657750456E-11 7.05741259862E-11 5.77087504806E-11 4.71104735715E-11 3.83943255194E-11 3.12380905983E-11 2.53725330344E-11 2.05730688348E-11 1.66526819425E-11 1.34559093481E-11 1.08537428595E-11 8.73931551289E-12 7.02425840028E-12 5.63562927066E-12 4.51332787580E-12 3.60792490839E-12 2.87884171697E-12 2.29282696175E-12 1.82268416186E-12 1.44621082026E-12 1.14531562986E-12 9.05285276584E-13 7.14176666050E-13 5.62314099559E-13 4.41874093472E-13 3.46543243543E-13 2.71236844964E-13 2.11867944050E-13 1.65158166379E-13 1.28483080465E-13 9.97460519079E-14 7.72755520454E-14 5.97417346748E-14 4.60888081161E-14 3.54803281556E-14 2.72550377707E-14 2.08912971039E-14 1.59784948376E-14 1.21941209573E-14 9.28542029697E-15 7.05474424675E-15 5.34788134300E-15 4.04478192317E-15 3.05220244229E-15 2.29788551345E-15 1.72596567376E-15 1.29335116707E-15 9.66881076470E-16 7.21096934746E-16 5.36500155350E-16 3.98192638664E-16 2.94818862184E-16 2.17744599147E-16 1.60420904233E-16 1.17892792919E-16 8.64206438180E-17 6.31891959445E-17 4.60844413547E-17 3.35230091646E-17 2.43220270491E-17 1.76001148233E-17 1.27022596128E-17 9.14296234390E-18 6.56332604614E-18 4.69875383674E-18 3.35469902310E-18 2.38850964096E-18 1.69587304990E-18 1.20072303153E-18 8.47745878401E-19 5.96831832855E-19 4.18978502103E-19 2.93274912232E-19 2.04687519494E-19 1.42439641001E-19 9.88287121300E-20 6.83656232801E-20 4.71502858560E-20 3.24199428251E-20 2.22234196858E-20 1.51869142811E-20 1.03461173910E-20 7.02624966555E-21 4.75660503824E-21 3.20986581781E-21 2.15914486989E-21 1.44767329275E-21 9.67479750008E-22 6.44442720614E-22 4.27844903463E-22 2.83097736931E-22 1.86690717887E-22 1.22696889434E-22 8.03631571439E-23 5.24542949054E-23 3.41187933396E-23 2.21147809802E-23 1.42835354546E-23 9.19264554064E-24 5.89501022842E-24 3.76665020844E-24 2.39794946679E-24 1.52098873006E-24 9.61170256777E-25 6.05131873638E-25 3.79543912144E-25 2.37150005000E-25 1.47611454730E-25 9.15249280292E-26 5.65285229642E-26 3.47769243111E-26 2.13106289721E-26 1.30067590882E-26 7.90670817091E-27 4.78698482357E-27 2.88638293983E-27 1.73323368549E-27 1.03647103184E-27 6.17219414364E-28 3.66007276688E-28 2.16118948755E-28 1.27067385028E-28 7.43872448442E-29 4.33581641313E-29 2.51614752683E-29 1.45371333377E-29 8.36148533936E-30 4.78778326498E-30 2.72907960111E-30 1.54850548938E-30 8.74597330382E-31 4.91684249617E-31 2.75125577089E-31 1.53223647661E-31 8.49286648051E-32 4.68489477696E-32 2.57185022774E-32 1.40499540234E-32 7.63783904457E-33 4.13157182608E-33 2.22378101097E-33 1.19092165635E-33 6.34557897344E-34 3.36386438439E-34 1.77405469663E-34 9.30762393998E-35 4.85775709963E-35 2.52196822790E-35 1.30236234909E-35 6.68950324185E-36 3.41748785082E-36 1.73640998435E-36 8.77426429121E-37 4.40923348308E-37 2.20338343792E-37 1.09489421126E-37 5.40990542957E-38 2.65780309887E-38 1.29822979758E-38 6.30457542289E-39 3.04379443931E-39 1.46086315312E-39 6.96976068268E-40 3.30536573682E-40 1.55809359031E-40 7.29993175167E-41 3.39917873756E-41 1.57303244013E-41 7.23416138736E-42 3.30600671464E-42 1.50128209620E-42 6.77394632575E-43 3.03682472315E-43 1.35261347525E-43 5.98523213285E-44 2.63098704393E-44 1.14885117673E-44 4.98302352599E-45 2.14675637942E-45 9.18564419785E-46 3.90345962062E-46 1.64732378607E-46 6.90356236252E-47 2.87281820693E-47 1.18702278253E-47 4.86968863172E-48 1.98339664028E-48 8.01971631351E-49 3.21902315754E-49 1.28256464475E-49 5.07222715891E-50 1.99093181947E-50 7.75579150965E-51 2.99834417905E-51 1.15025948598E-51 4.37867077665E-52 1.65384126569E-52 6.19759414370E-53 2.30410737829E-53 TDDFPT/Examples/pseudo/H.pbe-vbc.UPF0000644000175000017500000007756712341371476015316 0ustar mbamba Generated using Vanderbilt code, version 7 3 2 Author: Sit and Marzari Generation date: JCP 122 204510 (2005) Similar to local H PP generated by P.Giannozzi for LDA 0 The Pseudo was generated with a Non-Relativistic Calculation nl pn l occ Rcut Rcut US E pseu 0S 0 0 1.00 0.00000000000 0.00000000000 0.00000000000 0 Version Number H Element NC Norm - Conserving pseudopotential F Nonlinear Core Correction SLA PW PBE PBE PBE Exchange-Correlation functional 1.00000000000 Z valence 0.00000000000 Total energy 0.0000000 0.0000000 Suggested cutoff for wfc and rho -1 Max angular momentum component 325 Number of points in mesh 1 0 Number of Wavefunctions, Number of Projectors Wavefunctions nl l occ 0S 0 1.00 1.83156388887E-02 1.87793014947E-02 1.92547017754E-02 1.97421368715E-02 2.02419114458E-02 2.07543378737E-02 2.12797364384E-02 2.18184355310E-02 2.23707718562E-02 2.29370906419E-02 2.35177458560E-02 2.41131004268E-02 2.47235264703E-02 2.53494055227E-02 2.59911287788E-02 2.66490973364E-02 2.73237224473E-02 2.80154257742E-02 2.87246396542E-02 2.94518073691E-02 3.01973834223E-02 3.09618338232E-02 3.17456363781E-02 3.25492809891E-02 3.33732699603E-02 3.42181183117E-02 3.50843541008E-02 3.59725187534E-02 3.68831674012E-02 3.78168692293E-02 3.87742078317E-02 3.97557815762E-02 4.07622039784E-02 4.17941040849E-02 4.28521268670E-02 4.39369336234E-02 4.50492023936E-02 4.61896283817E-02 4.73589243911E-02 4.85578212700E-02 4.97870683679E-02 5.10474340042E-02 5.23397059484E-02 5.36646919127E-02 5.50232200564E-02 5.64161395038E-02 5.78443208748E-02 5.93086568294E-02 6.08100626252E-02 6.23494766897E-02 6.39278612067E-02 6.55462027180E-02 6.72055127397E-02 6.89068283947E-02 7.06512130604E-02 7.24397570343E-02 7.42735782143E-02 7.61538227986E-02 7.80816660012E-02 8.00583127867E-02 8.20849986239E-02 8.41629902573E-02 8.62935864994E-02 8.84781190421E-02 9.07179532894E-02 9.30144892107E-02 9.53691622155E-02 9.77834440514E-02 1.00258843723E-01 1.02796908435E-01 1.05399224562E-01 1.08067418635E-01 1.10803158362E-01 1.13608153671E-01 1.16484157773E-01 1.19432968267E-01 1.22456428253E-01 1.25556427493E-01 1.28734903588E-01 1.31993843188E-01 1.35335283237E-01 1.38761312243E-01 1.42274071587E-01 1.45875756856E-01 1.49568619223E-01 1.53354966845E-01 1.57237166314E-01 1.61217644130E-01 1.65298888222E-01 1.69483449499E-01 1.73773943450E-01 1.78173051773E-01 1.82683524053E-01 1.87308179482E-01 1.92049908621E-01 1.96911675204E-01 2.01896517995E-01 2.07007552681E-01 2.12247973827E-01 2.17621056865E-01 2.23130160148E-01 2.28778727045E-01 2.34570288094E-01 2.40508463208E-01 2.46596963942E-01 2.52839595805E-01 2.59240260646E-01 2.65802959089E-01 2.72531793034E-01 2.79430968221E-01 2.86504796860E-01 2.93757700324E-01 3.01194211912E-01 3.08818979688E-01 3.16636769379E-01 3.24652467358E-01 3.32871083698E-01 3.41297755301E-01 3.49937749111E-01 3.58796465406E-01 3.67879441171E-01 3.77192353563E-01 3.86741023455E-01 3.96531419075E-01 4.06569659741E-01 4.16862019679E-01 4.27414931949E-01 4.38234992465E-01 4.49328964117E-01 4.60703780999E-01 4.72366552741E-01 4.84324568955E-01 4.96585303791E-01 5.09156420608E-01 5.22045776761E-01 5.35261428519E-01 5.48811636094E-01 5.62704868807E-01 5.76949810380E-01 5.91555364367E-01 6.06530659713E-01 6.21885056465E-01 6.37628151622E-01 6.53769785130E-01 6.70320046036E-01 6.87289278791E-01 7.04688089719E-01 7.22527353642E-01 7.40818220682E-01 7.59572123225E-01 7.78800783071E-01 7.98516218759E-01 8.18730753078E-01 8.39457020769E-01 8.60707976425E-01 8.82496902585E-01 9.04837418036E-01 9.27743486329E-01 9.51229424501E-01 9.75309912028E-01 1.00000000000E+00 1.02531512052E+00 1.05127109638E+00 1.07788415088E+00 1.10517091808E+00 1.13314845307E+00 1.16183424273E+00 1.19124621661E+00 1.22140275816E+00 1.25232271619E+00 1.28402541669E+00 1.31653067487E+00 1.34985880758E+00 1.38403064598E+00 1.41906754859E+00 1.45499141462E+00 1.49182469764E+00 1.52959041966E+00 1.56831218549E+00 1.60801419749E+00 1.64872127070E+00 1.69045884838E+00 1.73325301787E+00 1.77713052691E+00 1.82211880039E+00 1.86824595743E+00 1.91554082901E+00 1.96403297597E+00 2.01375270747E+00 2.06473109997E+00 2.11700001661E+00 2.17059212718E+00 2.22554092849E+00 2.28188076533E+00 2.33964685193E+00 2.39887529397E+00 2.45960311116E+00 2.52186826036E+00 2.58570965932E+00 2.65116721098E+00 2.71828182846E+00 2.78709546057E+00 2.85765111806E+00 2.92999290053E+00 3.00416602395E+00 3.08021684892E+00 3.15819290969E+00 3.23814294384E+00 3.32011692274E+00 3.40416608279E+00 3.49034295746E+00 3.57870141010E+00 3.66929666762E+00 3.76218535500E+00 3.85742553070E+00 3.95507672292E+00 4.05519996684E+00 4.15785784276E+00 4.26311451517E+00 4.37103577293E+00 4.48168907034E+00 4.59514356931E+00 4.71147018259E+00 4.83074161811E+00 4.95303242440E+00 5.07841903718E+00 5.20697982718E+00 5.33879514907E+00 5.47394739173E+00 5.61252102969E+00 5.75460267601E+00 5.90028113632E+00 6.04964746441E+00 6.20279501910E+00 6.35981952260E+00 6.52081912033E+00 6.68589444228E+00 6.85514866590E+00 7.02868758059E+00 7.20661965382E+00 7.38905609893E+00 7.57611094464E+00 7.76790110631E+00 7.96454645903E+00 8.16616991257E+00 8.37289748813E+00 8.58485839718E+00 8.80218512219E+00 9.02501349943E+00 9.25348280391E+00 9.48773583636E+00 9.72791901256E+00 9.97418245481E+00 1.02266800858E+01 1.04855697247E+01 1.07510131861E+01 1.10231763806E+01 1.13022294193E+01 1.15883467192E+01 1.18817071131E+01 1.21824939607E+01 1.24908952636E+01 1.28071037827E+01 1.31313171585E+01 1.34637380350E+01 1.38045741861E+01 1.41540386454E+01 1.45123498396E+01 1.48797317249E+01 1.52564139269E+01 1.56426318842E+01 1.60386269957E+01 1.64446467711E+01 1.68609449861E+01 1.72877818406E+01 1.77254241215E+01 1.81741453694E+01 1.86342260499E+01 1.91059537282E+01 1.95896232496E+01 2.00855369232E+01 2.05940047112E+01 2.11153444225E+01 2.16498819115E+01 2.21979512814E+01 2.27598950935E+01 2.33360645809E+01 2.39268198684E+01 2.45325301971E+01 2.51535741558E+01 2.57903399172E+01 2.64432254806E+01 2.71126389207E+01 2.77989986427E+01 2.85027336438E+01 2.92242837812E+01 2.99641000474E+01 3.07226448515E+01 3.15003923087E+01 3.22978285366E+01 3.31154519587E+01 3.39537736162E+01 3.48133174876E+01 3.56946208157E+01 3.65982344437E+01 3.75247231596E+01 3.84746660490E+01 3.94486568572E+01 4.04473043601E+01 4.14712327448E+01 4.25210820001E+01 4.35975083157E+01 4.47011844933E+01 4.58328003663E+01 4.69930632316E+01 4.81826982911E+01 4.94024491055E+01 5.06530780588E+01 5.19353668348E+01 5.32501169057E+01 5.45981500331E+01 5.59803087816E+01 5.73974570454E+01 5.88504805883E+01 6.03402875974E+01 4.57890972218E-04 4.69482537367E-04 4.81367544385E-04 4.93553421787E-04 5.06047786145E-04 5.18858446842E-04 5.31993410959E-04 5.45460888276E-04 5.59269296404E-04 5.73427266048E-04 5.87943646400E-04 6.02827510670E-04 6.18088161758E-04 6.33735138068E-04 6.49778219469E-04 6.66227433409E-04 6.83093061182E-04 7.00385644356E-04 7.18115991356E-04 7.36295184228E-04 7.54934585558E-04 7.74045845579E-04 7.93640909452E-04 8.13732024728E-04 8.34331749008E-04 8.55452957792E-04 8.77108852521E-04 8.99312968836E-04 9.22079185031E-04 9.45421730733E-04 9.69355195793E-04 9.93894539406E-04 1.01905509946E-03 1.04485260212E-03 1.07130317168E-03 1.09842334059E-03 1.12623005984E-03 1.15474070954E-03 1.18397310978E-03 1.21394553175E-03 1.24467670920E-03 1.27618585010E-03 1.30849264871E-03 1.34161729782E-03 1.37558050141E-03 1.41040348759E-03 1.44610802187E-03 1.48271642074E-03 1.52025156563E-03 1.55873691724E-03 1.59819653017E-03 1.63865506795E-03 1.68013781849E-03 1.72267070987E-03 1.76628032651E-03 1.81099392586E-03 1.85683945536E-03 1.90384556997E-03 1.95204165003E-03 2.00145781967E-03 2.05212496560E-03 2.10407475643E-03 2.15733966248E-03 2.21195297605E-03 2.26794883224E-03 2.32536223027E-03 2.38422905539E-03 2.44458610128E-03 2.50647109307E-03 2.56992271088E-03 2.63498061405E-03 2.70168546587E-03 2.77007895906E-03 2.84020384177E-03 2.91210394434E-03 2.98582420667E-03 3.06141070632E-03 3.13891068733E-03 3.21837258970E-03 3.29984607970E-03 3.38338208092E-03 3.46903280607E-03 3.55685178966E-03 3.64689392141E-03 3.73921548057E-03 3.83387417112E-03 3.93092915784E-03 4.03044110324E-03 4.13247220554E-03 4.23708623749E-03 4.34434858626E-03 4.45432629432E-03 4.56708810132E-03 4.68270448705E-03 4.80124771552E-03 4.92279188010E-03 5.04741294987E-03 5.17518881703E-03 5.30619934567E-03 5.44052642163E-03 5.57825400371E-03 5.71946817613E-03 5.86425720234E-03 6.01271158021E-03 6.16492409854E-03 6.32098989512E-03 6.48100651615E-03 6.64507397722E-03 6.81329482585E-03 6.98577420554E-03 7.16261992150E-03 7.34394250809E-03 7.52985529781E-03 7.72047449220E-03 7.91591923448E-03 8.11631168396E-03 8.32177709245E-03 8.53244388252E-03 8.74844372778E-03 8.96991163515E-03 9.19698602929E-03 9.42980883908E-03 9.66852558636E-03 9.91328547687E-03 1.01642414935E-02 1.04215504920E-02 1.06853732987E-02 1.09558748116E-02 1.12332241029E-02 1.15175945250E-02 1.18091638185E-02 1.21081142239E-02 1.24146325948E-02 1.27289105152E-02 1.30511444190E-02 1.33815357130E-02 1.37202909024E-02 1.40676217202E-02 1.44237452595E-02 1.47888841092E-02 1.51632664928E-02 1.55471264116E-02 1.59407037905E-02 1.63442446282E-02 1.67580011509E-02 1.71822319698E-02 1.76172022430E-02 1.80631838411E-02 1.85204555170E-02 1.89893030806E-02 1.94700195768E-02 1.99629054690E-02 2.04682688269E-02 2.09864255192E-02 2.15176994106E-02 2.20624225646E-02 2.26209354509E-02 2.31935871582E-02 2.37807356125E-02 2.43827478007E-02 2.50000000000E-02 2.56328780131E-02 2.62817774094E-02 2.69471037721E-02 2.76292729519E-02 2.83287113267E-02 2.90458560682E-02 2.97811554153E-02 3.05350689540E-02 3.13080679048E-02 3.21006354172E-02 3.29132668717E-02 3.37464701894E-02 3.46007661495E-02 3.54766887148E-02 3.63747853655E-02 3.72956174410E-02 3.82397604916E-02 3.92078046373E-02 4.02003549371E-02 4.12180317675E-02 4.22614712095E-02 4.33313254467E-02 4.44282631729E-02 4.55529700098E-02 4.67061489358E-02 4.78885207253E-02 4.91008243992E-02 5.03438176868E-02 5.16182774992E-02 5.29250004153E-02 5.42648031796E-02 5.56385232123E-02 5.70470191332E-02 5.84911712981E-02 5.99718823492E-02 6.14900777789E-02 6.30467065090E-02 6.46427414829E-02 6.62791802746E-02 6.79570457115E-02 6.96773865141E-02 7.14412779516E-02 7.32498225133E-02 7.51041505987E-02 7.70054212230E-02 7.89548227422E-02 8.09535735959E-02 8.30029230684E-02 8.51041520698E-02 8.72585739365E-02 8.94675352525E-02 9.17324166905E-02 9.40546338750E-02 9.64356382674E-02 9.88769180730E-02 1.01379999171E-01 1.03946446069E-01 1.06577862879E-01 1.09275894323E-01 1.12042226758E-01 1.14878589233E-01 1.17786754565E-01 1.20768540453E-01 1.23825810610E-01 1.26960475930E-01 1.30174495679E-01 1.33469878727E-01 1.36848684793E-01 1.40313025742E-01 1.43865066900E-01 1.47507028408E-01 1.51241186610E-01 1.55069875478E-01 1.58995488065E-01 1.63020478008E-01 1.67147361057E-01 1.71378716647E-01 1.75717189515E-01 1.80165491346E-01 1.84726402473E-01 1.89402773616E-01 1.94197527658E-01 1.99113661476E-01 2.04154247814E-01 2.09322437203E-01 2.14621459929E-01 2.20054628055E-01 2.25625337486E-01 2.31337070098E-01 2.37193395909E-01 2.43197975314E-01 2.49354561370E-01 2.55667002145E-01 2.62139243118E-01 2.68775329652E-01 2.75579409516E-01 2.82555735482E-01 2.89708667981E-01 2.97042677827E-01 3.04562349018E-01 3.12272381590E-01 3.20177594567E-01 3.28282928962E-01 3.36593450875E-01 3.45114354652E-01 3.53850966134E-01 3.62808745990E-01 3.71993293122E-01 3.81410348171E-01 3.91065797105E-01 4.00965674891E-01 4.11116169277E-01 4.21523624652E-01 4.32194546014E-01 4.43135603037E-01 4.54353634236E-01 4.65855651247E-01 4.77648843206E-01 4.89740581240E-01 5.02138423080E-01 5.14850117780E-01 5.27883610564E-01 5.41247047788E-01 5.54948782036E-01 5.68997377338E-01 5.83401614524E-01 5.98170496709E-01 6.13313254928E-01 6.28839353895E-01 6.44758497930E-01 6.61080637014E-01 6.77815973016E-01 6.94974966067E-01 7.12568341094E-01 7.30607094531E-01 7.49102501185E-01 7.68066121288E-01 7.87509807719E-01 8.07445713415E-01 8.27886298967E-01 8.48844340406E-01 8.70332937190E-01 8.92365520391E-01 9.14955861092E-01 9.38118078990E-01 9.61866651226E-01 9.86216421430E-01 1.01118260900E+00 1.03678081862E+00 1.06302705000E+00 1.08993770789E+00 1.11752961233E+00 1.14582000916E+00 1.17482658079E+00 1.20456745728E+00 1.23506122764E+00 1.26632695147E+00 1.29838417087E+00 1.33125292264E+00 1.36495375083E+00 1.39950771954E+00 1.43493642614E+00 1.47126201471E+00 1.50850718993E+00 -9.22514970000E+00 -9.22514970000E+00 -9.22507120001E+00 -9.22498869998E+00 -9.22490170002E+00 -9.22481020002E+00 -9.22471379997E+00 -9.22461220004E+00 -9.22450519998E+00 -9.22439250000E+00 -9.22427380002E+00 -9.22414870001E+00 -9.22401680003E+00 -9.22387780000E+00 -9.22373129999E+00 -9.22357680000E+00 -9.22341399998E+00 -9.22324220002E+00 -9.22306110003E+00 -9.22287009999E+00 -9.22266849999E+00 -9.22245579999E+00 -9.22223129998E+00 -9.22199430001E+00 -9.22174410000E+00 -9.22147990000E+00 -9.22120090002E+00 -9.22090610001E+00 -9.22059470001E+00 -9.22026550000E+00 -9.21991740001E+00 -9.21954950000E+00 -9.21916030000E+00 -9.21874850001E+00 -9.21831270000E+00 -9.21785150000E+00 -9.21736310000E+00 -9.21684579999E+00 -9.21629770002E+00 -9.21571679999E+00 -9.21510089999E+00 -9.21444779999E+00 -9.21375480001E+00 -9.21301940001E+00 -9.21223860000E+00 -9.21140929999E+00 -9.21052810000E+00 -9.20959150001E+00 -9.20859560000E+00 -9.20753599999E+00 -9.20640839999E+00 -9.20520780000E+00 -9.20392890001E+00 -9.20256600000E+00 -9.20111300000E+00 -9.19956309999E+00 -9.19790920001E+00 -9.19614340000E+00 -9.19425729999E+00 -9.19224170001E+00 -9.19008670000E+00 -9.18778160000E+00 -9.18531469999E+00 -9.18267340000E+00 -9.17984400000E+00 -9.17681170000E+00 -9.17356040001E+00 -9.17007260000E+00 -9.16632949998E+00 -9.16231040002E+00 -9.15799309999E+00 -9.15335339998E+00 -9.14836510001E+00 -9.14299979998E+00 -9.13722660007E+00 -9.13101209996E+00 -9.12431989999E+00 -9.11711070000E+00 -9.10934200000E+00 -9.10096749997E+00 -9.09193709999E+00 -9.08219680002E+00 -9.07168769997E+00 -9.06034659998E+00 -9.04810489995E+00 -9.03488829997E+00 -9.02061679996E+00 -9.00520400000E+00 -8.98855690000E+00 -8.97057480004E+00 -8.95114990003E+00 -8.93016589999E+00 -8.90749799997E+00 -8.88301210001E+00 -8.85656490000E+00 -8.82800280003E+00 -8.79716160000E+00 -8.76386660001E+00 -8.72793160000E+00 -8.68915869999E+00 -8.64733870002E+00 -8.60224999999E+00 -8.55365949999E+00 -8.50132200002E+00 -8.44498149997E+00 -8.38437059999E+00 -8.31921229999E+00 -8.24922110000E+00 -8.17410380000E+00 -8.09356240000E+00 -8.00729610001E+00 -7.91500460000E+00 -7.81639160001E+00 -7.71116940000E+00 -7.59906399999E+00 -7.47982150002E+00 -7.35321460001E+00 -7.21905119999E+00 -7.07718330001E+00 -6.92751690000E+00 -6.77002330000E+00 -6.60475180000E+00 -6.43184209999E+00 -6.25153869999E+00 -6.06420470000E+00 -5.87033740000E+00 -5.67058130000E+00 -5.46574260001E+00 -5.25680070000E+00 -5.04491720001E+00 -4.83144220000E+00 -4.61791520000E+00 -4.40605890000E+00 -4.19776620000E+00 -3.99507589999E+00 -3.80013610000E+00 -3.61515409999E+00 -3.44232750000E+00 -3.28375810000E+00 -3.14134320000E+00 -3.01664640000E+00 -2.91074720000E+00 -2.82407310000E+00 -2.75622240000E+00 -2.70579190000E+00 -2.67023360000E+00 -2.64577950000E+00 -2.62749229999E+00 -2.60953000000E+00 -2.58574930000E+00 -2.55082610000E+00 -2.50214380000E+00 -2.44285770000E+00 -2.38249500000E+00 -2.32366860000E+00 -2.26629650000E+00 -2.21034190000E+00 -2.15576860000E+00 -2.10254219999E+00 -2.05063040000E+00 -1.99999990000E+00 -1.95061990001E+00 -1.90245889999E+00 -1.85548700001E+00 -1.80967479999E+00 -1.76499390000E+00 -1.72141609999E+00 -1.67891410000E+00 -1.63746170000E+00 -1.59703250001E+00 -1.55760150000E+00 -1.51914430000E+00 -1.48163649999E+00 -1.44505480000E+00 -1.40937630001E+00 -1.37457850000E+00 -1.34064010000E+00 -1.30753970000E+00 -1.27525640000E+00 -1.24377010000E+00 -1.21306130000E+00 -1.18311070000E+00 -1.15389970000E+00 -1.12540970001E+00 -1.09762320000E+00 -1.07052280000E+00 -1.04409150000E+00 -1.01831280000E+00 -9.93170600000E-01 -9.68649119999E-01 -9.44733089999E-01 -9.21407540001E-01 -8.98657910002E-01 -8.76469969999E-01 -8.54829879997E-01 -8.33724019997E-01 -8.13139279998E-01 -7.93062849998E-01 -7.73482029999E-01 -7.54384720001E-01 -7.35758930001E-01 -7.17592910001E-01 -6.99875420002E-01 -6.82595490002E-01 -6.65742239998E-01 -6.49304900001E-01 -6.33273460001E-01 -6.17638020000E-01 -6.02388460000E-01 -5.87515369999E-01 -5.73009589999E-01 -5.58861929999E-01 -5.45063590001E-01 -5.31605920001E-01 -5.18480500000E-01 -5.05679160000E-01 -4.93193920000E-01 -4.81016899999E-01 -4.69140509999E-01 -4.57557410000E-01 -4.46260279999E-01 -4.35242050000E-01 -4.24495900000E-01 -4.14015050000E-01 -4.03792979999E-01 -3.93823310000E-01 -3.84099779999E-01 -3.74616330001E-01 -3.65367019999E-01 -3.56346080000E-01 -3.47547860000E-01 -3.38966870000E-01 -3.30597750000E-01 -3.22435270000E-01 -3.14474309999E-01 -3.06709910000E-01 -2.99137220000E-01 -2.91751490000E-01 -2.84548119999E-01 -2.77522600000E-01 -2.70670540000E-01 -2.63987660001E-01 -2.57469780000E-01 -2.51112830000E-01 -2.44912830000E-01 -2.38865910000E-01 -2.32968290000E-01 -2.27216279999E-01 -2.21606290000E-01 -2.16134810000E-01 -2.10798430000E-01 -2.05593790000E-01 -2.00517660000E-01 -1.95566870000E-01 -1.90738300001E-01 -1.86028959999E-01 -1.81435880001E-01 -1.76956210000E-01 -1.72587590001E-01 -1.68326330000E-01 -1.64170330000E-01 -1.60116950000E-01 -1.56163279999E-01 -1.52307640000E-01 -1.48547160000E-01 -1.44879510000E-01 -1.41302430000E-01 -1.37813660000E-01 -1.34411020000E-01 -1.31092400000E-01 -1.27855720000E-01 -1.24698950000E-01 -1.21620120000E-01 -1.18617310000E-01 -1.15688640000E-01 -1.12832280000E-01 -1.10046440000E-01 -1.07329380000E-01 -1.04679410000E-01 -1.02094870000E-01 -9.95741359998E-02 -9.71156420000E-02 -9.47178480001E-02 -9.23792559999E-02 -9.00984040003E-02 -8.78738670000E-02 -8.57042530002E-02 -8.35882080001E-02 -8.15244080000E-02 -7.95115630002E-02 -7.75484150000E-02 -7.56337379998E-02 -7.37663350001E-02 -7.19450369999E-02 -7.01687079999E-02 -6.84362360000E-02 -6.67465400001E-02 -6.50985620000E-02 -6.34912730000E-02 -6.19236669999E-02 -6.03947669998E-02 -5.89036139999E-02 -5.74492790000E-02 -5.60308509998E-02 -5.46474450000E-02 -5.32981940001E-02 -5.19822570000E-02 -5.06988110001E-02 -4.94470530000E-02 -4.82262010000E-02 -4.70354920001E-02 -4.58741809999E-02 -4.47415440000E-02 -4.36368709999E-02 -4.25594729999E-02 -4.15086760000E-02 -4.04838229999E-02 -3.94842740001E-02 -3.85094030001E-02 -3.75586030001E-02 -3.66312780000E-02 -3.57268479999E-02 -3.48447490001E-02 -3.39844290000E-02 -3.31453510001E-02 0 Number of nonzero Dij 0S 0 1.00 Wavefunction 2.91358770000E-02 2.98727560000E-02 3.06282340000E-02 3.14027790000E-02 3.21968680000E-02 3.30109920000E-02 3.38456520000E-02 3.47013620000E-02 3.55786490000E-02 3.64780530000E-02 3.74001260000E-02 3.83454340000E-02 3.93145580000E-02 4.03080910000E-02 4.13266410000E-02 4.23708320000E-02 4.34413010000E-02 4.45387020000E-02 4.56637030000E-02 4.68169880000E-02 4.79992590000E-02 4.92112330000E-02 5.04536450000E-02 5.17272460000E-02 5.30328040000E-02 5.43711080000E-02 5.57429620000E-02 5.71491900000E-02 5.85906340000E-02 6.00681570000E-02 6.15826400000E-02 6.31349830000E-02 6.47261080000E-02 6.63569570000E-02 6.80284910000E-02 6.97416960000E-02 7.14975740000E-02 7.32971520000E-02 7.51414790000E-02 7.70316240000E-02 7.89686800000E-02 8.09537600000E-02 8.29880030000E-02 8.50725680000E-02 8.72086380000E-02 8.93974180000E-02 9.16401370000E-02 9.39380460000E-02 9.62924200000E-02 9.87045540000E-02 1.01175770000E-01 1.03707410000E-01 1.06300830000E-01 1.08957430000E-01 1.11678610000E-01 1.14465790000E-01 1.17320430000E-01 1.20243990000E-01 1.23237960000E-01 1.26303840000E-01 1.29443160000E-01 1.32657440000E-01 1.35948240000E-01 1.39317130000E-01 1.42765670000E-01 1.46295450000E-01 1.49908050000E-01 1.53605070000E-01 1.57388110000E-01 1.61258770000E-01 1.65218620000E-01 1.69269260000E-01 1.73412260000E-01 1.77649180000E-01 1.81981550000E-01 1.86410900000E-01 1.90938700000E-01 1.95566400000E-01 2.00295420000E-01 2.05127120000E-01 2.10062790000E-01 2.15103700000E-01 2.20251000000E-01 2.25505790000E-01 2.30869090000E-01 2.36341780000E-01 2.41924680000E-01 2.47618450000E-01 2.53423640000E-01 2.59340640000E-01 2.65369680000E-01 2.71510830000E-01 2.77763960000E-01 2.84128720000E-01 2.90604570000E-01 2.97190700000E-01 3.03886070000E-01 3.10689340000E-01 3.17598890000E-01 3.24612770000E-01 3.31728730000E-01 3.38944140000E-01 3.46256000000E-01 3.53660940000E-01 3.61155170000E-01 3.68734470000E-01 3.76394210000E-01 3.84129270000E-01 3.91934100000E-01 3.99802680000E-01 4.07728490000E-01 4.15704580000E-01 4.23723500000E-01 4.31777360000E-01 4.39857850000E-01 4.47956210000E-01 4.56063350000E-01 4.64169810000E-01 4.72265860000E-01 4.80341560000E-01 4.88386810000E-01 4.96391440000E-01 5.04345300000E-01 5.12238380000E-01 5.20060900000E-01 5.27803420000E-01 5.35456970000E-01 5.43013200000E-01 5.50464410000E-01 5.57803750000E-01 5.65025260000E-01 5.72123970000E-01 5.79095890000E-01 5.85938080000E-01 5.92648550000E-01 5.99226180000E-01 6.05670550000E-01 6.11981700000E-01 6.18159790000E-01 6.24204750000E-01 6.30115740000E-01 6.35890730000E-01 6.41525860000E-01 6.47014960000E-01 6.52349060000E-01 6.57516110000E-01 6.62500840000E-01 6.67285060000E-01 6.71848280000E-01 6.76168860000E-01 6.80225500000E-01 6.83998950000E-01 6.87473210000E-01 6.90635280000E-01 6.93473270000E-01 6.95975490000E-01 6.98130450000E-01 6.99926950000E-01 7.01354050000E-01 7.02401160000E-01 7.03058080000E-01 7.03315010000E-01 7.03162670000E-01 7.02592250000E-01 7.01595560000E-01 7.00164990000E-01 6.98293630000E-01 6.95975280000E-01 6.93204500000E-01 6.89976690000E-01 6.86288100000E-01 6.82135910000E-01 6.77518270000E-01 6.72434340000E-01 6.66884340000E-01 6.60869610000E-01 6.54392600000E-01 6.47456980000E-01 6.40067620000E-01 6.32230650000E-01 6.23953450000E-01 6.15244730000E-01 6.06114480000E-01 5.96574040000E-01 5.86636040000E-01 5.76314420000E-01 5.65624440000E-01 5.54582590000E-01 5.43206620000E-01 5.31515440000E-01 5.19529090000E-01 5.07268640000E-01 4.94756170000E-01 4.82014600000E-01 4.69067670000E-01 4.55939760000E-01 4.42655850000E-01 4.29241350000E-01 4.15721980000E-01 4.02123700000E-01 3.88472520000E-01 3.74794440000E-01 3.61115310000E-01 3.47460740000E-01 3.33855980000E-01 3.20325830000E-01 3.06894610000E-01 2.93586030000E-01 2.80423130000E-01 2.67428270000E-01 2.54623050000E-01 2.42028250000E-01 2.29663830000E-01 2.17548840000E-01 2.05701420000E-01 1.94138720000E-01 1.82876880000E-01 1.71930930000E-01 1.61314770000E-01 1.51041100000E-01 1.41121300000E-01 1.31565420000E-01 1.22382080000E-01 1.13578380000E-01 1.05159900000E-01 9.71305910000E-02 8.94927600000E-02 8.22470580000E-02 7.53924670000E-02 6.89263160000E-02 6.28443150000E-02 5.71406130000E-02 5.18078650000E-02 4.68373260000E-02 4.22189570000E-02 3.79415420000E-02 3.39928170000E-02 3.03596130000E-02 2.70279990000E-02 2.39834250000E-02 2.12108790000E-02 1.86950240000E-02 1.64203480000E-02 1.43712960000E-02 1.25323970000E-02 1.08883890000E-02 9.42431840000E-03 8.12564640000E-03 6.97832680000E-03 5.96888160000E-03 5.08446040000E-03 4.31288770000E-03 3.64269890000E-03 3.06316420000E-03 2.56430190000E-03 2.13688210000E-03 1.77242110000E-03 1.46316760000E-03 1.20208120000E-03 9.82822840000E-04 7.99615700000E-04 6.47602140000E-04 5.21934490000E-04 4.18337470000E-04 3.33380530000E-04 2.64122950000E-04 2.07998930000E-04 1.62794640000E-04 1.26612460000E-04 9.78366880000E-05 7.51010130000E-05 5.72580630000E-05 4.33511370000E-05 3.25882930000E-05 2.43188140000E-05 1.80120550000E-05 1.32386210000E-05 9.65378020000E-06 6.98300200000E-06 5.00945730000E-06 3.56332890000E-06 2.51278260000E-06 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 8.48899328559E-04 8.92381551036E-04 9.38088717959E-04 9.86134528923E-04 1.03663830901E-03 1.08972559282E-03 1.14552815931E-03 1.20418452466E-03 1.26584026467E-03 1.33064835067E-03 1.39876942482E-03 1.47037230865E-03 1.54563447074E-03 1.62474220006E-03 1.70789125634E-03 1.79528740437E-03 1.88714663257E-03 1.98369597584E-03 2.08517377167E-03 2.19183036539E-03 2.30392886455E-03 2.42174545338E-03 2.54557029379E-03 2.67570797874E-03 2.81247830010E-03 2.95621738515E-03 3.10727781253E-03 3.26602991766E-03 3.43286239252E-03 3.60818348538E-03 3.79242154937E-03 3.98602607841E-03 4.18946905683E-03 4.40324574230E-03 4.62787558774E-03 4.86390416096E-03 5.11190308789E-03 5.37247249131E-03 5.64624186631E-03 5.93387109608E-03 6.23605242094E-03 6.55351125814E-03 6.88700864193E-03 7.23734182611E-03 7.60534654182E-03 7.99189834507E-03 8.39791470938E-03 8.82435648630E-03 9.27223014946E-03 9.74258898034E-03 1.02365364351E-02 1.07552268889E-02 1.12998664587E-02 1.18717215522E-02 1.24721119315E-02 1.31024170803E-02 1.37640832954E-02 1.44586171311E-02 1.51875947850E-02 1.59526599987E-02 1.67555316708E-02 1.75979963874E-02 1.84819239591E-02 1.94092627114E-02 2.03820365305E-02 2.14023586907E-02 2.24724234548E-02 2.35945175297E-02 2.47710171694E-02 2.60043909019E-02 2.72971923947E-02 2.86520823809E-02 3.00718119183E-02 3.15592311547E-02 3.31172845404E-02 3.47490236388E-02 3.64575871577E-02 3.82462168090E-02 4.01182552730E-02 4.20771353595E-02 4.41263757426E-02 4.62696017537E-02 4.85105030010E-02 5.08528613235E-02 5.33005367174E-02 5.58574369736E-02 5.85275507931E-02 6.13148967804E-02 6.42235413108E-02 6.72575675556E-02 7.04210670633E-02 7.37181308073E-02 7.71528174749E-02 8.07291295288E-02 8.44510161049E-02 8.83223121665E-02 9.23467435400E-02 9.65278659896E-02 1.00869054929E-01 1.05373450447E-01 1.10043950307E-01 1.14883130040E-01 1.19893217536E-01 1.25076060482E-01 1.30433056818E-01 1.35965109366E-01 1.41672601322E-01 1.47555296071E-01 1.53612338743E-01 1.59842182935E-01 1.66242521558E-01 1.72810297833E-01 1.79541604452E-01 1.86431688609E-01 1.93474928207E-01 2.00664766078E-01 2.07993779213E-01 2.15453612515E-01 2.23035042522E-01 2.30728014263E-01 2.38521676182E-01 2.46404461705E-01 2.54364181632E-01 2.62388157945E-01 2.70463339709E-01 2.78576450164E-01 2.86714166722E-01 2.94863335374E-01 3.03011066677E-01 3.11145023514E-01 3.19253544438E-01 3.27325837049E-01 3.35352049815E-01 3.43323433594E-01 3.51232303817E-01 3.59072014797E-01 3.66836815137E-01 3.74521601135E-01 3.82121525973E-01 3.89631569923E-01 3.97045845796E-01 4.04357020500E-01 4.11555429049E-01 4.18628358464E-01 4.25559296083E-01 4.32327434910E-01 4.38907363001E-01 4.45269351299E-01 4.51380111339E-01 4.57204327234E-01 4.62706730850E-01 4.67854563601E-01 4.72619414468E-01 4.76977089981E-01 4.80905176204E-01 4.84381882681E-01 4.87386125217E-01 4.89897735336E-01 4.91897503451E-01 4.93367389569E-01 4.94290663853E-01 4.94652003291E-01 4.94437740482E-01 4.93635869760E-01 4.92236329812E-01 4.90231013222E-01 4.87613993699E-01 4.84381590371E-01 4.80532478820E-01 4.76067832743E-01 4.70991356202E-01 4.65309399712E-01 4.59031006184E-01 4.52167941611E-01 4.44734722937E-01 4.36748641422E-01 4.28229674935E-01 4.19200540951E-01 4.09686558172E-01 3.99715594799E-01 3.89317907767E-01 3.78526077793E-01 3.67374762866E-01 3.55900585202E-01 3.44141843427E-01 3.32138310700E-01 3.19931007125E-01 3.07561849131E-01 2.95073432012E-01 2.82508662958E-01 2.69910475356E-01 2.57321473127E-01 2.44783667753E-01 2.32338074613E-01 2.20024479039E-01 2.07881064749E-01 1.95944201539E-01 1.84248136550E-01 1.72824764655E-01 1.61703470102E-01 1.50910898795E-01 1.40470872255E-01 1.30404267116E-01 1.20728965841E-01 1.11459815382E-01 1.02608637365E-01 9.41843016471E-02 8.61927570112E-02 7.86371318390E-02 7.15178795952E-02 6.48328975913E-02 5.85776737981E-02 5.27454748103E-02 4.73274977853E-02 4.23130741900E-02 3.76898426032E-02 3.34439532385E-02 2.95602446907E-02 2.60224550202E-02 2.28134138892E-02 1.99152213137E-02 1.73094597398E-02 1.49773735051E-02 1.29000484034E-02 1.10586045680E-02 9.43435170801E-03 8.00895409242E-03 6.76457854966E-03 5.68402408035E-03 4.75083703733E-03 3.94940792782E-03 3.26504965402E-03 2.68405487586E-03 2.19373510683E-03 1.78244033017E-03 1.43956060934E-03 1.15551160760E-03 9.21706101510E-04 7.30512729944E-04 5.75204674731E-04 4.49901387953E-04 3.49503922361E-04 2.69627828441E-04 2.06534148720E-04 1.57060974566E-04 1.18557015015E-04 8.88177773046E-05 6.60261294178E-05 4.86970449276E-05 3.56275475548E-05 2.58517375592E-05 1.86010003128E-05 1.32692552761E-05 9.38297491616E-06 6.57564423434E-06 4.56626510930E-06 3.14147655573E-06 2.14085942569E-06 1.44499921139E-06 9.65940734826E-07 6.39385267686E-07 4.19388531733E-07 2.72415611852E-07 1.75006238806E-07 1.11142577783E-07 6.97609327167E-08 4.32635548811E-08 2.65020948127E-08 1.60307150273E-08 9.57201751881E-09 5.64016215363E-09 3.27848577851E-09 1.87932107919E-09 1.06199684065E-09 5.91404714367E-10 3.24434125323E-10 1.75261085982E-10 9.31954721499E-11 4.87623169320E-11 2.50946624405E-11 1.26973128496E-11 6.31407639486E-12 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 TDDFPT/Examples/pseudo/H.pbe-rrkjus.UPF0000644000175000017500000056223012341371476016046 0ustar mbamba Generated using Andrea Dal Corso code (rrkj3) Author: Andrea Dal Corso Generation date: unknown Info: H LDA 1s1 RRKJ3 US 0 The Pseudo was generated with a Non-Relativistic Calculation 1.10000000000E+00 Local Potential cutoff radius nl pn l occ Rcut Rcut US E pseu 1S 1 0 1.00 1.10000000000 1.20000000000 0.00000000000 1S 1 0 0.00 1.10000000000 1.20000000000 0.00000000000 2P 2 1 0.00 1.10000000000 1.10000000000 0.00000000000 0 Version Number H Element US Ultrasoft pseudopotential F Nonlinear Core Correction SLA PW PBE PBE PBE Exchange-Correlation functional 1.00000000000 Z valence -0.61916649298 Total energy 0.0000000 0.0000000 Suggested cutoff for wfc and rho 1 Max angular momentum component 1061 Number of points in mesh 1 2 Number of Wavefunctions, Number of Projectors Wavefunctions nl l occ 1S 0 1.00 2.47875217667E-03 2.50366405020E-03 2.52882629223E-03 2.55424141899E-03 2.57991197203E-03 2.60584051841E-03 2.63202965101E-03 2.65848198878E-03 2.68520017695E-03 2.71218688739E-03 2.73944481877E-03 2.76697669691E-03 2.79478527504E-03 2.82287333402E-03 2.85124368268E-03 2.87989915809E-03 2.90884262581E-03 2.93807698022E-03 2.96760514478E-03 2.99743007233E-03 3.02755474538E-03 3.05798217642E-03 3.08871540824E-03 3.11975751416E-03 3.15111159844E-03 3.18278079651E-03 3.21476827531E-03 3.24707723361E-03 3.27971090234E-03 3.31267254490E-03 3.34596545747E-03 3.37959296938E-03 3.41355844340E-03 3.44786527610E-03 3.48251689821E-03 3.51751677491E-03 3.55286840622E-03 3.58857532733E-03 3.62464110897E-03 3.66106935773E-03 3.69786371648E-03 3.73502786469E-03 3.77256551879E-03 3.81048043259E-03 3.84877639761E-03 3.88745724348E-03 3.92652683831E-03 3.96598908909E-03 4.00584794209E-03 4.04610738322E-03 4.08677143846E-03 4.12784417426E-03 4.16932969790E-03 4.21123215800E-03 4.25355574482E-03 4.29630469075E-03 4.33948327074E-03 4.38309580267E-03 4.42714664783E-03 4.47164021135E-03 4.51658094261E-03 4.56197333574E-03 4.60782192999E-03 4.65413131028E-03 4.70090610758E-03 4.74815099941E-03 4.79587071030E-03 4.84407001225E-03 4.89275372524E-03 4.94192671768E-03 4.99159390691E-03 5.04176025969E-03 5.09243079270E-03 5.14361057303E-03 5.19530471871E-03 5.24751839918E-03 5.30025683587E-03 5.35352530266E-03 5.40732912644E-03 5.46167368764E-03 5.51656442076E-03 5.57200681492E-03 5.62800641440E-03 5.68456881922E-03 5.74169968565E-03 5.79940472684E-03 5.85768971334E-03 5.91656047368E-03 5.97602289501E-03 6.03608292360E-03 6.09674656552E-03 6.15801988717E-03 6.21990901594E-03 6.28242014080E-03 6.34555951291E-03 6.40933344626E-03 6.47374831829E-03 6.53881057055E-03 6.60452670931E-03 6.67090330626E-03 6.73794699909E-03 6.80566449223E-03 6.87406255750E-03 6.94314803475E-03 7.01292783259E-03 7.08340892905E-03 7.15459837231E-03 7.22650328138E-03 7.29913084679E-03 7.37248833137E-03 7.44658307092E-03 7.52142247499E-03 7.59701402758E-03 7.67336528790E-03 7.75048389114E-03 7.82837754923E-03 7.90705405159E-03 7.98652126596E-03 8.06678713910E-03 8.14785969768E-03 8.22974704902E-03 8.31245738192E-03 8.39599896749E-03 8.48038015995E-03 8.56560939750E-03 8.65169520312E-03 8.73864618547E-03 8.82647103973E-03 8.91517854844E-03 9.00477758244E-03 9.09527710170E-03 9.18668615624E-03 9.27901388706E-03 9.37226952701E-03 9.46646240171E-03 9.56160193054E-03 9.65769762754E-03 9.75475910234E-03 9.85279606119E-03 9.95181830785E-03 1.00518357446E-02 1.01528583734E-02 1.02548962964E-02 1.03579597176E-02 1.04620589434E-02 1.05672043839E-02 1.06734065535E-02 1.07806760727E-02 1.08890236686E-02 1.09984601758E-02 1.11089965382E-02 1.12206438096E-02 1.13334131547E-02 1.14473158505E-02 1.15623632875E-02 1.16785669704E-02 1.17959385198E-02 1.19144896728E-02 1.20342322847E-02 1.21551783299E-02 1.22773399031E-02 1.24007292204E-02 1.25253586211E-02 1.26512405680E-02 1.27783876495E-02 1.29068125805E-02 1.30365282034E-02 1.31675474901E-02 1.32998835424E-02 1.34335495942E-02 1.35685590122E-02 1.37049252974E-02 1.38426620865E-02 1.39817831533E-02 1.41223024102E-02 1.42642339090E-02 1.44075918431E-02 1.45523905484E-02 1.46986445049E-02 1.48463683381E-02 1.49955768205E-02 1.51462848730E-02 1.52985075667E-02 1.54522601239E-02 1.56075579200E-02 1.57644164849E-02 1.59228515045E-02 1.60828788226E-02 1.62445144419E-02 1.64077745263E-02 1.65726754018E-02 1.67392335586E-02 1.69074656527E-02 1.70773885075E-02 1.72490191153E-02 1.74223746395E-02 1.75974724156E-02 1.77743299537E-02 1.79529649395E-02 1.81333952368E-02 1.83156388887E-02 1.84997141198E-02 1.86856393377E-02 1.88734331352E-02 1.90631142916E-02 1.92547017754E-02 1.94482147454E-02 1.96436725531E-02 1.98410947444E-02 2.00405010617E-02 2.02419114458E-02 2.04453460379E-02 2.06508251817E-02 2.08583694252E-02 2.10679995230E-02 2.12797364384E-02 2.14936013451E-02 2.17096156298E-02 2.19278008943E-02 2.21481789570E-02 2.23707718562E-02 2.25956018511E-02 2.28226914251E-02 2.30520632872E-02 2.32837403749E-02 2.35177458560E-02 2.37541031313E-02 2.39928358367E-02 2.42339678457E-02 2.44775232717E-02 2.47235264703E-02 2.49720020423E-02 2.52229748352E-02 2.54764699467E-02 2.57325127264E-02 2.59911287788E-02 2.62523439657E-02 2.65161844089E-02 2.67826764926E-02 2.70518468664E-02 2.73237224473E-02 2.75983304232E-02 2.78756982552E-02 2.81558536803E-02 2.84388247142E-02 2.87246396542E-02 2.90133270822E-02 2.93049158670E-02 2.95994351679E-02 2.98969144369E-02 3.01973834223E-02 3.05008721712E-02 3.08074110328E-02 3.11170306611E-02 3.14297620184E-02 3.17456363781E-02 3.20646853279E-02 3.23869407729E-02 3.27124349390E-02 3.30412003759E-02 3.33732699603E-02 3.37086768996E-02 3.40474547346E-02 3.43896373435E-02 3.47352589447E-02 3.50843541008E-02 3.54369577216E-02 3.57931050677E-02 3.61528317540E-02 3.65161737537E-02 3.68831674012E-02 3.72538493962E-02 3.76282568072E-02 3.80064270752E-02 3.83883980176E-02 3.87742078317E-02 3.91638950990E-02 3.95574987884E-02 3.99550582607E-02 4.03566132720E-02 4.07622039784E-02 4.11718709391E-02 4.15856551212E-02 4.20035979034E-02 4.24257410805E-02 4.28521268670E-02 4.32827979020E-02 4.37177972528E-02 4.41571684197E-02 4.46009553403E-02 4.50492023936E-02 4.55019544046E-02 4.59592566490E-02 4.64211548574E-02 4.68876952200E-02 4.73589243911E-02 4.78348894942E-02 4.83156381261E-02 4.88012183620E-02 4.92916787605E-02 4.97870683679E-02 5.02874367236E-02 5.07928338649E-02 5.13033103319E-02 5.18189171727E-02 5.23397059484E-02 5.28657287384E-02 5.33970381452E-02 5.39336873004E-02 5.44757298692E-02 5.50232200564E-02 5.55762126115E-02 5.61347628341E-02 5.66989265798E-02 5.72687602655E-02 5.78443208748E-02 5.84256659645E-02 5.90128536694E-02 5.96059427089E-02 6.02049923924E-02 6.08100626252E-02 6.14212139150E-02 6.20385073774E-02 6.26620047422E-02 6.32917683596E-02 6.39278612067E-02 6.45703468932E-02 6.52192896681E-02 6.58747544264E-02 6.65368067150E-02 6.72055127397E-02 6.78809393718E-02 6.85631541543E-02 6.92522253093E-02 6.99482217447E-02 7.06512130604E-02 7.13612695564E-02 7.20784622388E-02 7.28028628274E-02 7.35345437631E-02 7.42735782143E-02 7.50200400853E-02 7.57740040228E-02 7.65355454239E-02 7.73047404433E-02 7.80816660012E-02 7.88663997907E-02 7.96590202859E-02 8.04596067495E-02 8.12682392409E-02 8.20849986239E-02 8.29099665752E-02 8.37432255922E-02 8.45848590016E-02 8.54349509673E-02 8.62935864994E-02 8.71608514620E-02 8.80368325824E-02 8.89216174594E-02 8.98152945722E-02 9.07179532894E-02 9.16296838775E-02 9.25505775103E-02 9.34807262781E-02 9.44202231963E-02 9.53691622155E-02 9.63276382305E-02 9.72957470895E-02 9.82735856044E-02 9.92612515596E-02 1.00258843723E-01 1.01266461854E-01 1.02284206716E-01 1.03312180083E-01 1.04350484755E-01 1.05399224562E-01 1.06458504379E-01 1.07528430136E-01 1.08609108825E-01 1.09700648516E-01 1.10803158362E-01 1.11916748617E-01 1.13041530640E-01 1.14177616911E-01 1.15325121038E-01 1.16484157773E-01 1.17654843022E-01 1.18837293852E-01 1.20031628511E-01 1.21237966433E-01 1.22456428253E-01 1.23687135817E-01 1.24930212199E-01 1.26185781705E-01 1.27453969895E-01 1.28734903588E-01 1.30028710878E-01 1.31335521148E-01 1.32655465080E-01 1.33988674669E-01 1.35335283237E-01 1.36695425446E-01 1.38069237311E-01 1.39456856215E-01 1.40858420921E-01 1.42274071587E-01 1.43703949778E-01 1.45148198484E-01 1.46606962130E-01 1.48080386595E-01 1.49568619223E-01 1.51071808836E-01 1.52590105757E-01 1.54123661815E-01 1.55672630368E-01 1.57237166314E-01 1.58817426107E-01 1.60413567775E-01 1.62025750934E-01 1.63654136803E-01 1.65298888222E-01 1.66960169667E-01 1.68638147269E-01 1.70332988825E-01 1.72044863823E-01 1.73773943450E-01 1.75520400617E-01 1.77284409970E-01 1.79066147911E-01 1.80865792617E-01 1.82683524053E-01 1.84519523993E-01 1.86373976039E-01 1.88247065639E-01 1.90138980102E-01 1.92049908621E-01 1.93980042291E-01 1.95929574127E-01 1.97898699084E-01 1.99887614075E-01 2.01896517995E-01 2.03925611734E-01 2.05975098205E-01 2.08045182357E-01 2.10136071201E-01 2.12247973827E-01 2.14381101427E-01 2.16535667316E-01 2.18711886952E-01 2.20909977959E-01 2.23130160148E-01 2.25372655539E-01 2.27637688384E-01 2.29925485187E-01 2.32236274730E-01 2.34570288094E-01 2.36927758682E-01 2.39308922244E-01 2.41714016897E-01 2.44143283153E-01 2.46596963942E-01 2.49075304632E-01 2.51578553060E-01 2.54106959553E-01 2.56660776954E-01 2.59240260646E-01 2.61845668580E-01 2.64477261300E-01 2.67135301966E-01 2.69820056385E-01 2.72531793034E-01 2.75270783090E-01 2.78037300453E-01 2.80831621778E-01 2.83654026500E-01 2.86504796860E-01 2.89384217939E-01 2.92292577681E-01 2.95230166924E-01 2.98197279430E-01 3.01194211912E-01 3.04221264067E-01 3.07278738601E-01 3.10366941265E-01 3.13486180883E-01 3.16636769379E-01 3.19819021816E-01 3.23033256422E-01 3.26279794623E-01 3.29558961075E-01 3.32871083698E-01 3.36216493707E-01 3.39595525645E-01 3.43008517419E-01 3.46455810330E-01 3.49937749111E-01 3.53454681959E-01 3.57006960569E-01 3.60594940173E-01 3.64218979572E-01 3.67879441171E-01 3.71576691022E-01 3.75311098851E-01 3.79083038103E-01 3.82892885975E-01 3.86741023455E-01 3.90627835359E-01 3.94553710372E-01 3.98519041085E-01 4.02524224034E-01 4.06569659741E-01 4.10655752752E-01 4.14782911682E-01 4.18951549248E-01 4.23162082318E-01 4.27414931949E-01 4.31710523429E-01 4.36049286322E-01 4.40431654506E-01 4.44858066223E-01 4.49328964117E-01 4.53844795282E-01 4.58406011305E-01 4.63013068311E-01 4.67666427010E-01 4.72366552741E-01 4.77113915521E-01 4.81908990090E-01 4.86752255960E-01 4.91644197461E-01 4.96585303791E-01 5.01576069066E-01 5.06616992366E-01 5.11708577787E-01 5.16851334492E-01 5.22045776761E-01 5.27292424043E-01 5.32591801007E-01 5.37944437595E-01 5.43350869074E-01 5.48811636094E-01 5.54327284735E-01 5.59898366565E-01 5.65525438700E-01 5.71209063849E-01 5.76949810380E-01 5.82748252374E-01 5.88604969678E-01 5.94520547970E-01 6.00495578812E-01 6.06530659713E-01 6.12626394184E-01 6.18783391806E-01 6.25002268283E-01 6.31283645507E-01 6.37628151622E-01 6.44036421083E-01 6.50509094723E-01 6.57046819815E-01 6.63650250136E-01 6.70320046036E-01 6.77056874498E-01 6.83861409212E-01 6.90734330637E-01 6.97676326071E-01 7.04688089719E-01 7.11770322763E-01 7.18923733432E-01 7.26149037074E-01 7.33446956224E-01 7.40818220682E-01 7.48263567579E-01 7.55783741456E-01 7.63379494337E-01 7.71051585804E-01 7.78800783071E-01 7.86627861067E-01 7.94533602503E-01 8.02518797962E-01 8.10584245970E-01 8.18730753078E-01 8.26959133943E-01 8.35270211411E-01 8.43664816596E-01 8.52143788966E-01 8.60707976425E-01 8.69358235399E-01 8.78095430921E-01 8.86920436717E-01 8.95834135297E-01 9.04837418036E-01 9.13931185271E-01 9.23116346387E-01 9.32393819906E-01 9.41764533584E-01 9.51229424501E-01 9.60789439152E-01 9.70445533549E-01 9.80198673307E-01 9.90049833749E-01 1.00000000000E+00 1.01005016708E+00 1.02020134003E+00 1.03045453395E+00 1.04081077419E+00 1.05127109638E+00 1.06183654655E+00 1.07250818125E+00 1.08328706767E+00 1.09417428371E+00 1.10517091808E+00 1.11627807046E+00 1.12749685158E+00 1.13882838332E+00 1.15027379886E+00 1.16183424273E+00 1.17351087099E+00 1.18530485132E+00 1.19721736312E+00 1.20924959766E+00 1.22140275816E+00 1.23367805996E+00 1.24607673059E+00 1.25860000993E+00 1.27124915032E+00 1.28402541669E+00 1.29693008667E+00 1.30996445073E+00 1.32312981234E+00 1.33642748803E+00 1.34985880758E+00 1.36342511413E+00 1.37712776434E+00 1.39096812846E+00 1.40494759056E+00 1.41906754859E+00 1.43332941456E+00 1.44773461466E+00 1.46228458943E+00 1.47698079388E+00 1.49182469764E+00 1.50681778511E+00 1.52196155562E+00 1.53725752355E+00 1.55270721851E+00 1.56831218549E+00 1.58407398499E+00 1.59999419322E+00 1.61607440219E+00 1.63231621996E+00 1.64872127070E+00 1.66529119495E+00 1.68202764970E+00 1.69893230862E+00 1.71600686218E+00 1.73325301787E+00 1.75067250030E+00 1.76826705143E+00 1.78603843075E+00 1.80398841540E+00 1.82211880039E+00 1.84043139878E+00 1.85892804185E+00 1.87761057926E+00 1.89648087930E+00 1.91554082901E+00 1.93479233440E+00 1.95423732064E+00 1.97387773223E+00 1.99371553324E+00 2.01375270747E+00 2.03399125865E+00 2.05443321064E+00 2.07508060767E+00 2.09593551449E+00 2.11700001661E+00 2.13827622050E+00 2.15976625378E+00 2.18147226550E+00 2.20339642626E+00 2.22554092849E+00 2.24790798668E+00 2.27049983753E+00 2.29331874026E+00 2.31636697678E+00 2.33964685193E+00 2.36316069371E+00 2.38691085352E+00 2.41089970642E+00 2.43512965129E+00 2.45960311116E+00 2.48432253338E+00 2.50929038994E+00 2.53450917762E+00 2.55998141833E+00 2.58570965932E+00 2.61169647342E+00 2.63794445935E+00 2.66445624193E+00 2.69123447235E+00 2.71828182846E+00 2.74560101502E+00 2.77319476396E+00 2.80106583470E+00 2.82921701435E+00 2.85765111806E+00 2.88637098927E+00 2.91537949998E+00 2.94467955107E+00 2.97427407256E+00 3.00416602395E+00 3.03435839444E+00 3.06485420329E+00 3.09565650012E+00 3.12676836519E+00 3.15819290969E+00 3.18993327612E+00 3.22199263853E+00 3.25437420289E+00 3.28708120738E+00 3.32011692274E+00 3.35348465255E+00 3.38718773362E+00 3.42122953629E+00 3.45561346476E+00 3.49034295746E+00 3.52542148737E+00 3.56085256236E+00 3.59663972557E+00 3.63278655575E+00 3.66929666762E+00 3.70617371221E+00 3.74342137726E+00 3.78104338757E+00 3.81904350537E+00 3.85742553070E+00 3.89619330180E+00 3.93535069547E+00 3.97490162749E+00 4.01485005299E+00 4.05519996684E+00 4.09595540407E+00 4.13712044025E+00 4.17869919192E+00 4.22069581700E+00 4.26311451517E+00 4.30595952835E+00 4.34923514106E+00 4.39294568092E+00 4.43709551900E+00 4.48168907034E+00 4.52673079431E+00 4.57222519514E+00 4.61817682230E+00 4.66459027099E+00 4.71147018259E+00 4.75882124514E+00 4.80664819378E+00 4.85495581124E+00 4.90374892833E+00 4.95303242440E+00 5.00281122783E+00 5.05309031656E+00 5.10387471854E+00 5.15516951223E+00 5.20697982718E+00 5.25931084445E+00 5.31216779718E+00 5.36555597112E+00 5.41948070513E+00 5.47394739173E+00 5.52896147762E+00 5.58452846428E+00 5.64065390843E+00 5.69734342267E+00 5.75460267601E+00 5.81243739440E+00 5.87085336138E+00 5.92985641859E+00 5.98945246638E+00 6.04964746441E+00 6.11044743223E+00 6.17185844988E+00 6.23388665852E+00 6.29653826103E+00 6.35981952260E+00 6.42373677143E+00 6.48829639929E+00 6.55350486219E+00 6.61936868104E+00 6.68589444228E+00 6.75308879853E+00 6.82095846929E+00 6.88951024158E+00 6.95875097064E+00 7.02868758059E+00 7.09932706516E+00 7.17067648835E+00 7.24274298516E+00 7.31553376231E+00 7.38905609893E+00 7.46331734732E+00 7.53832493366E+00 7.61408635878E+00 7.69060919888E+00 7.76790110631E+00 7.84596981032E+00 7.92482311785E+00 8.00446891430E+00 8.08491516431E+00 8.16616991257E+00 8.24824128463E+00 8.33113748769E+00 8.41486681144E+00 8.49943762889E+00 8.58485839718E+00 8.67113765846E+00 8.75828404074E+00 8.84630625872E+00 8.93521311470E+00 9.02501349943E+00 9.11571639304E+00 9.20733086588E+00 9.29986607948E+00 9.39333128744E+00 9.48773583636E+00 9.58308916676E+00 9.67940081407E+00 9.77668040953E+00 9.87493768117E+00 9.97418245481E+00 1.00744246550E+01 1.01756743061E+01 1.02779415330E+01 1.03812365627E+01 1.04855697247E+01 1.05909514524E+01 1.06973922841E+01 1.08049028639E+01 1.09134939430E+01 1.10231763806E+01 1.11339611451E+01 1.12458593149E+01 1.13588820800E+01 1.14730407428E+01 1.15883467192E+01 1.17048115400E+01 1.18224468516E+01 1.19412644178E+01 1.20612761204E+01 1.21824939607E+01 1.23049300605E+01 1.24285966636E+01 1.25535061367E+01 1.26796709708E+01 1.28071037827E+01 1.29358173155E+01 1.30658244409E+01 1.31971381597E+01 1.33297716032E+01 1.34637380350E+01 1.35990508518E+01 1.37357235851E+01 1.38737699021E+01 1.40132036077E+01 1.41540386454E+01 1.42962890987E+01 1.44399691928E+01 1.45850932959E+01 1.47316759204E+01 1.48797317249E+01 1.50292755149E+01 1.51803222450E+01 1.53328870199E+01 1.54869850963E+01 1.56426318842E+01 1.57998429483E+01 1.59586340098E+01 1.61190209480E+01 1.62810198018E+01 1.64446467711E+01 1.66099182188E+01 1.67768506721E+01 1.69454608245E+01 1.71157655371E+01 1.72877818406E+01 1.74615269366E+01 1.76370181998E+01 1.78142731796E+01 1.79933096016E+01 1.81741453694E+01 1.83567985670E+01 1.85412874597E+01 1.87276304967E+01 1.89158463123E+01 1.91059537282E+01 1.92979717555E+01 1.94919195960E+01 1.96878166448E+01 1.98856824916E+01 2.00855369232E+01 2.02873999252E+01 2.04912916842E+01 2.06972325894E+01 2.09052432351E+01 2.11153444225E+01 2.13275571620E+01 2.15419026750E+01 2.17584023962E+01 2.19770779758E+01 2.21979512814E+01 2.24210444007E+01 2.26463796432E+01 2.28739795424E+01 2.31038668587E+01 2.33360645809E+01 2.35705959291E+01 2.38074843564E+01 2.40467535521E+01 2.42884274431E+01 2.45325301971E+01 2.47790862246E+01 2.50281201813E+01 2.52796569710E+01 2.55337217474E+01 2.57903399172E+01 2.60495371425E+01 2.63113393433E+01 2.65757726999E+01 2.68428636559E+01 2.71126389207E+01 2.73851254719E+01 2.76603505585E+01 2.79383417032E+01 2.82191267054E+01 2.85027336438E+01 2.87891908792E+01 2.90785270578E+01 2.93707711133E+01 2.96659522704E+01 2.99641000474E+01 3.02652442594E+01 3.05694150211E+01 3.08766427497E+01 3.11869581683E+01 3.15003923087E+01 3.18169765147E+01 3.21367424448E+01 3.24597220759E+01 3.27859477062E+01 3.31154519587E+01 3.34482677839E+01 3.37844284638E+01 3.41239676148E+01 3.44669191909E+01 3.48133174876E+01 3.51631971451E+01 3.55165931516E+01 3.58735408471E+01 3.62340759265E+01 3.65982344437E+01 3.69660528148E+01 3.73375678221E+01 3.77128166172E+01 3.80918367254E+01 3.84746660490E+01 3.88613428713E+01 3.92519058603E+01 3.96463940726E+01 4.00448469573E+01 4.04473043601E+01 4.08538065270E+01 4.12643941086E+01 4.16791081640E+01 4.20979901650E+01 4.25210820001E+01 4.29484259788E+01 4.33800648359E+01 4.38160417356E+01 4.42564002760E+01 4.47011844933E+01 4.51504388663E+01 4.56042083208E+01 4.60625382342E+01 4.65254744398E+01 4.69930632316E+01 4.74653513689E+01 4.79423860808E+01 4.84242150713E+01 4.89108865237E+01 4.94024491055E+01 4.98989519734E+01 5.04004447781E+01 5.09069776692E+01 5.14186013005E+01 5.19353668348E+01 5.24573259491E+01 5.29845308397E+01 5.35170342275E+01 5.40548893633E+01 5.45981500331E+01 5.51468705635E+01 5.57011058268E+01 5.62609112471E+01 5.68263428055E+01 5.73974570454E+01 5.79743110790E+01 5.85569625919E+01 5.91454698499E+01 5.97398917041E+01 6.03402875974E+01 6.09467175696E+01 6.15592422644E+01 6.21779229348E+01 6.28028214492E+01 6.34340002981E+01 6.40715225999E+01 6.47154521074E+01 6.53658532140E+01 6.60227909604E+01 6.66863310409E+01 6.73565398101E+01 6.80334842894E+01 6.87172321738E+01 6.94078518388E+01 7.01054123467E+01 7.08099834543E+01 7.15216356192E+01 7.22404400073E+01 7.29664684996E+01 7.36997936996E+01 7.44404889403E+01 7.51886282920E+01 7.59442865692E+01 7.67075393383E+01 7.74784629253E+01 7.82571344231E+01 7.90436316996E+01 7.98380334051E+01 8.06404189805E+01 8.14508686650E+01 8.22694635042E+01 8.30962853583E+01 8.39314169103E+01 8.47749416738E+01 8.56269440022E+01 8.64875090963E+01 8.73567230134E+01 8.82346726757E+01 8.91214458787E+01 9.00171313005E+01 9.09218185105E+01 9.18355979782E+01 9.27585610821E+01 9.36908001195E+01 9.46324083149E+01 9.55834798301E+01 9.65441097728E+01 9.75143942071E+01 9.84944301619E+01 9.94843156419E+01 2.47875217667E-05 2.50366405020E-05 2.52882629223E-05 2.55424141899E-05 2.57991197203E-05 2.60584051841E-05 2.63202965101E-05 2.65848198878E-05 2.68520017695E-05 2.71218688739E-05 2.73944481877E-05 2.76697669691E-05 2.79478527504E-05 2.82287333402E-05 2.85124368268E-05 2.87989915809E-05 2.90884262581E-05 2.93807698022E-05 2.96760514478E-05 2.99743007233E-05 3.02755474538E-05 3.05798217642E-05 3.08871540824E-05 3.11975751416E-05 3.15111159844E-05 3.18278079651E-05 3.21476827531E-05 3.24707723361E-05 3.27971090234E-05 3.31267254490E-05 3.34596545747E-05 3.37959296938E-05 3.41355844340E-05 3.44786527610E-05 3.48251689821E-05 3.51751677491E-05 3.55286840622E-05 3.58857532733E-05 3.62464110897E-05 3.66106935773E-05 3.69786371648E-05 3.73502786469E-05 3.77256551879E-05 3.81048043259E-05 3.84877639761E-05 3.88745724348E-05 3.92652683831E-05 3.96598908909E-05 4.00584794209E-05 4.04610738322E-05 4.08677143846E-05 4.12784417426E-05 4.16932969790E-05 4.21123215800E-05 4.25355574482E-05 4.29630469075E-05 4.33948327074E-05 4.38309580267E-05 4.42714664783E-05 4.47164021135E-05 4.51658094261E-05 4.56197333574E-05 4.60782192999E-05 4.65413131028E-05 4.70090610758E-05 4.74815099941E-05 4.79587071030E-05 4.84407001225E-05 4.89275372524E-05 4.94192671768E-05 4.99159390691E-05 5.04176025969E-05 5.09243079270E-05 5.14361057303E-05 5.19530471871E-05 5.24751839918E-05 5.30025683587E-05 5.35352530266E-05 5.40732912644E-05 5.46167368764E-05 5.51656442076E-05 5.57200681492E-05 5.62800641440E-05 5.68456881922E-05 5.74169968565E-05 5.79940472684E-05 5.85768971334E-05 5.91656047368E-05 5.97602289501E-05 6.03608292360E-05 6.09674656552E-05 6.15801988717E-05 6.21990901594E-05 6.28242014080E-05 6.34555951291E-05 6.40933344626E-05 6.47374831829E-05 6.53881057055E-05 6.60452670931E-05 6.67090330626E-05 6.73794699909E-05 6.80566449223E-05 6.87406255750E-05 6.94314803475E-05 7.01292783259E-05 7.08340892905E-05 7.15459837231E-05 7.22650328138E-05 7.29913084679E-05 7.37248833137E-05 7.44658307092E-05 7.52142247499E-05 7.59701402758E-05 7.67336528790E-05 7.75048389114E-05 7.82837754923E-05 7.90705405159E-05 7.98652126596E-05 8.06678713910E-05 8.14785969768E-05 8.22974704902E-05 8.31245738192E-05 8.39599896749E-05 8.48038015995E-05 8.56560939750E-05 8.65169520312E-05 8.73864618547E-05 8.82647103973E-05 8.91517854844E-05 9.00477758244E-05 9.09527710170E-05 9.18668615624E-05 9.27901388706E-05 9.37226952701E-05 9.46646240171E-05 9.56160193054E-05 9.65769762754E-05 9.75475910234E-05 9.85279606119E-05 9.95181830785E-05 1.00518357446E-04 1.01528583734E-04 1.02548962964E-04 1.03579597176E-04 1.04620589434E-04 1.05672043839E-04 1.06734065535E-04 1.07806760727E-04 1.08890236686E-04 1.09984601758E-04 1.11089965382E-04 1.12206438096E-04 1.13334131547E-04 1.14473158505E-04 1.15623632875E-04 1.16785669704E-04 1.17959385198E-04 1.19144896728E-04 1.20342322847E-04 1.21551783299E-04 1.22773399031E-04 1.24007292204E-04 1.25253586211E-04 1.26512405680E-04 1.27783876495E-04 1.29068125805E-04 1.30365282034E-04 1.31675474901E-04 1.32998835424E-04 1.34335495942E-04 1.35685590122E-04 1.37049252974E-04 1.38426620865E-04 1.39817831533E-04 1.41223024102E-04 1.42642339090E-04 1.44075918431E-04 1.45523905484E-04 1.46986445049E-04 1.48463683381E-04 1.49955768205E-04 1.51462848730E-04 1.52985075667E-04 1.54522601239E-04 1.56075579200E-04 1.57644164849E-04 1.59228515045E-04 1.60828788226E-04 1.62445144419E-04 1.64077745263E-04 1.65726754018E-04 1.67392335586E-04 1.69074656527E-04 1.70773885075E-04 1.72490191153E-04 1.74223746395E-04 1.75974724156E-04 1.77743299537E-04 1.79529649395E-04 1.81333952368E-04 1.83156388887E-04 1.84997141198E-04 1.86856393377E-04 1.88734331352E-04 1.90631142916E-04 1.92547017754E-04 1.94482147454E-04 1.96436725531E-04 1.98410947444E-04 2.00405010617E-04 2.02419114458E-04 2.04453460379E-04 2.06508251817E-04 2.08583694252E-04 2.10679995230E-04 2.12797364384E-04 2.14936013451E-04 2.17096156298E-04 2.19278008943E-04 2.21481789570E-04 2.23707718562E-04 2.25956018511E-04 2.28226914251E-04 2.30520632872E-04 2.32837403749E-04 2.35177458560E-04 2.37541031313E-04 2.39928358367E-04 2.42339678457E-04 2.44775232717E-04 2.47235264703E-04 2.49720020423E-04 2.52229748352E-04 2.54764699467E-04 2.57325127264E-04 2.59911287788E-04 2.62523439657E-04 2.65161844089E-04 2.67826764926E-04 2.70518468664E-04 2.73237224473E-04 2.75983304232E-04 2.78756982552E-04 2.81558536803E-04 2.84388247142E-04 2.87246396542E-04 2.90133270822E-04 2.93049158670E-04 2.95994351679E-04 2.98969144369E-04 3.01973834223E-04 3.05008721712E-04 3.08074110328E-04 3.11170306611E-04 3.14297620184E-04 3.17456363781E-04 3.20646853279E-04 3.23869407729E-04 3.27124349390E-04 3.30412003759E-04 3.33732699603E-04 3.37086768996E-04 3.40474547346E-04 3.43896373435E-04 3.47352589447E-04 3.50843541008E-04 3.54369577216E-04 3.57931050677E-04 3.61528317540E-04 3.65161737537E-04 3.68831674012E-04 3.72538493962E-04 3.76282568072E-04 3.80064270752E-04 3.83883980176E-04 3.87742078317E-04 3.91638950990E-04 3.95574987884E-04 3.99550582607E-04 4.03566132720E-04 4.07622039784E-04 4.11718709391E-04 4.15856551212E-04 4.20035979034E-04 4.24257410805E-04 4.28521268670E-04 4.32827979020E-04 4.37177972528E-04 4.41571684197E-04 4.46009553403E-04 4.50492023936E-04 4.55019544046E-04 4.59592566490E-04 4.64211548574E-04 4.68876952200E-04 4.73589243911E-04 4.78348894942E-04 4.83156381261E-04 4.88012183620E-04 4.92916787605E-04 4.97870683679E-04 5.02874367236E-04 5.07928338649E-04 5.13033103319E-04 5.18189171727E-04 5.23397059484E-04 5.28657287384E-04 5.33970381452E-04 5.39336873004E-04 5.44757298692E-04 5.50232200564E-04 5.55762126115E-04 5.61347628341E-04 5.66989265798E-04 5.72687602655E-04 5.78443208748E-04 5.84256659645E-04 5.90128536694E-04 5.96059427089E-04 6.02049923924E-04 6.08100626252E-04 6.14212139150E-04 6.20385073774E-04 6.26620047422E-04 6.32917683596E-04 6.39278612067E-04 6.45703468932E-04 6.52192896681E-04 6.58747544264E-04 6.65368067150E-04 6.72055127397E-04 6.78809393718E-04 6.85631541543E-04 6.92522253093E-04 6.99482217447E-04 7.06512130604E-04 7.13612695564E-04 7.20784622388E-04 7.28028628274E-04 7.35345437631E-04 7.42735782143E-04 7.50200400853E-04 7.57740040228E-04 7.65355454239E-04 7.73047404433E-04 7.80816660012E-04 7.88663997907E-04 7.96590202859E-04 8.04596067495E-04 8.12682392409E-04 8.20849986239E-04 8.29099665752E-04 8.37432255922E-04 8.45848590016E-04 8.54349509673E-04 8.62935864994E-04 8.71608514620E-04 8.80368325824E-04 8.89216174594E-04 8.98152945722E-04 9.07179532894E-04 9.16296838775E-04 9.25505775103E-04 9.34807262781E-04 9.44202231963E-04 9.53691622155E-04 9.63276382305E-04 9.72957470895E-04 9.82735856044E-04 9.92612515596E-04 1.00258843723E-03 1.01266461854E-03 1.02284206716E-03 1.03312180083E-03 1.04350484755E-03 1.05399224562E-03 1.06458504379E-03 1.07528430136E-03 1.08609108825E-03 1.09700648516E-03 1.10803158362E-03 1.11916748617E-03 1.13041530640E-03 1.14177616911E-03 1.15325121038E-03 1.16484157773E-03 1.17654843022E-03 1.18837293852E-03 1.20031628511E-03 1.21237966433E-03 1.22456428253E-03 1.23687135817E-03 1.24930212199E-03 1.26185781705E-03 1.27453969895E-03 1.28734903588E-03 1.30028710878E-03 1.31335521148E-03 1.32655465080E-03 1.33988674669E-03 1.35335283237E-03 1.36695425446E-03 1.38069237311E-03 1.39456856215E-03 1.40858420921E-03 1.42274071587E-03 1.43703949778E-03 1.45148198484E-03 1.46606962130E-03 1.48080386595E-03 1.49568619223E-03 1.51071808836E-03 1.52590105757E-03 1.54123661815E-03 1.55672630368E-03 1.57237166314E-03 1.58817426107E-03 1.60413567775E-03 1.62025750934E-03 1.63654136803E-03 1.65298888222E-03 1.66960169667E-03 1.68638147269E-03 1.70332988825E-03 1.72044863823E-03 1.73773943450E-03 1.75520400617E-03 1.77284409970E-03 1.79066147911E-03 1.80865792617E-03 1.82683524053E-03 1.84519523993E-03 1.86373976039E-03 1.88247065639E-03 1.90138980102E-03 1.92049908621E-03 1.93980042291E-03 1.95929574127E-03 1.97898699084E-03 1.99887614075E-03 2.01896517995E-03 2.03925611734E-03 2.05975098205E-03 2.08045182357E-03 2.10136071201E-03 2.12247973827E-03 2.14381101427E-03 2.16535667316E-03 2.18711886952E-03 2.20909977959E-03 2.23130160148E-03 2.25372655539E-03 2.27637688384E-03 2.29925485187E-03 2.32236274730E-03 2.34570288094E-03 2.36927758682E-03 2.39308922244E-03 2.41714016897E-03 2.44143283153E-03 2.46596963942E-03 2.49075304632E-03 2.51578553060E-03 2.54106959553E-03 2.56660776954E-03 2.59240260646E-03 2.61845668580E-03 2.64477261300E-03 2.67135301966E-03 2.69820056385E-03 2.72531793034E-03 2.75270783090E-03 2.78037300453E-03 2.80831621778E-03 2.83654026500E-03 2.86504796860E-03 2.89384217939E-03 2.92292577681E-03 2.95230166924E-03 2.98197279430E-03 3.01194211912E-03 3.04221264067E-03 3.07278738601E-03 3.10366941265E-03 3.13486180883E-03 3.16636769379E-03 3.19819021816E-03 3.23033256422E-03 3.26279794623E-03 3.29558961075E-03 3.32871083698E-03 3.36216493707E-03 3.39595525645E-03 3.43008517419E-03 3.46455810330E-03 3.49937749111E-03 3.53454681959E-03 3.57006960569E-03 3.60594940173E-03 3.64218979572E-03 3.67879441171E-03 3.71576691022E-03 3.75311098851E-03 3.79083038103E-03 3.82892885975E-03 3.86741023455E-03 3.90627835359E-03 3.94553710372E-03 3.98519041085E-03 4.02524224034E-03 4.06569659741E-03 4.10655752752E-03 4.14782911682E-03 4.18951549248E-03 4.23162082318E-03 4.27414931949E-03 4.31710523429E-03 4.36049286322E-03 4.40431654506E-03 4.44858066223E-03 4.49328964117E-03 4.53844795282E-03 4.58406011305E-03 4.63013068311E-03 4.67666427010E-03 4.72366552741E-03 4.77113915521E-03 4.81908990090E-03 4.86752255960E-03 4.91644197461E-03 4.96585303791E-03 5.01576069066E-03 5.06616992366E-03 5.11708577787E-03 5.16851334492E-03 5.22045776761E-03 5.27292424043E-03 5.32591801007E-03 5.37944437595E-03 5.43350869074E-03 5.48811636094E-03 5.54327284735E-03 5.59898366565E-03 5.65525438700E-03 5.71209063849E-03 5.76949810380E-03 5.82748252374E-03 5.88604969678E-03 5.94520547970E-03 6.00495578812E-03 6.06530659713E-03 6.12626394184E-03 6.18783391806E-03 6.25002268283E-03 6.31283645507E-03 6.37628151622E-03 6.44036421083E-03 6.50509094723E-03 6.57046819815E-03 6.63650250136E-03 6.70320046036E-03 6.77056874498E-03 6.83861409212E-03 6.90734330637E-03 6.97676326071E-03 7.04688089719E-03 7.11770322763E-03 7.18923733432E-03 7.26149037074E-03 7.33446956224E-03 7.40818220682E-03 7.48263567579E-03 7.55783741456E-03 7.63379494337E-03 7.71051585804E-03 7.78800783071E-03 7.86627861067E-03 7.94533602503E-03 8.02518797962E-03 8.10584245970E-03 8.18730753078E-03 8.26959133943E-03 8.35270211411E-03 8.43664816596E-03 8.52143788966E-03 8.60707976425E-03 8.69358235399E-03 8.78095430921E-03 8.86920436717E-03 8.95834135297E-03 9.04837418036E-03 9.13931185271E-03 9.23116346387E-03 9.32393819906E-03 9.41764533584E-03 9.51229424501E-03 9.60789439152E-03 9.70445533549E-03 9.80198673307E-03 9.90049833749E-03 1.00000000000E-02 1.01005016708E-02 1.02020134003E-02 1.03045453395E-02 1.04081077419E-02 1.05127109638E-02 1.06183654655E-02 1.07250818125E-02 1.08328706767E-02 1.09417428371E-02 1.10517091808E-02 1.11627807046E-02 1.12749685158E-02 1.13882838332E-02 1.15027379886E-02 1.16183424273E-02 1.17351087099E-02 1.18530485132E-02 1.19721736312E-02 1.20924959766E-02 1.22140275816E-02 1.23367805996E-02 1.24607673059E-02 1.25860000993E-02 1.27124915032E-02 1.28402541669E-02 1.29693008667E-02 1.30996445073E-02 1.32312981234E-02 1.33642748803E-02 1.34985880758E-02 1.36342511413E-02 1.37712776434E-02 1.39096812846E-02 1.40494759056E-02 1.41906754859E-02 1.43332941456E-02 1.44773461466E-02 1.46228458943E-02 1.47698079388E-02 1.49182469764E-02 1.50681778511E-02 1.52196155562E-02 1.53725752355E-02 1.55270721851E-02 1.56831218549E-02 1.58407398499E-02 1.59999419322E-02 1.61607440219E-02 1.63231621996E-02 1.64872127070E-02 1.66529119495E-02 1.68202764970E-02 1.69893230862E-02 1.71600686218E-02 1.73325301787E-02 1.75067250030E-02 1.76826705143E-02 1.78603843075E-02 1.80398841540E-02 1.82211880039E-02 1.84043139878E-02 1.85892804185E-02 1.87761057926E-02 1.89648087930E-02 1.91554082901E-02 1.93479233440E-02 1.95423732064E-02 1.97387773223E-02 1.99371553324E-02 2.01375270747E-02 2.03399125865E-02 2.05443321064E-02 2.07508060767E-02 2.09593551449E-02 2.11700001661E-02 2.13827622050E-02 2.15976625378E-02 2.18147226550E-02 2.20339642626E-02 2.22554092849E-02 2.24790798668E-02 2.27049983753E-02 2.29331874026E-02 2.31636697678E-02 2.33964685193E-02 2.36316069371E-02 2.38691085352E-02 2.41089970642E-02 2.43512965129E-02 2.45960311116E-02 2.48432253338E-02 2.50929038994E-02 2.53450917762E-02 2.55998141833E-02 2.58570965932E-02 2.61169647342E-02 2.63794445935E-02 2.66445624193E-02 2.69123447235E-02 2.71828182846E-02 2.74560101502E-02 2.77319476396E-02 2.80106583470E-02 2.82921701435E-02 2.85765111806E-02 2.88637098927E-02 2.91537949998E-02 2.94467955107E-02 2.97427407256E-02 3.00416602395E-02 3.03435839444E-02 3.06485420329E-02 3.09565650012E-02 3.12676836519E-02 3.15819290969E-02 3.18993327612E-02 3.22199263853E-02 3.25437420289E-02 3.28708120738E-02 3.32011692274E-02 3.35348465255E-02 3.38718773362E-02 3.42122953629E-02 3.45561346476E-02 3.49034295746E-02 3.52542148737E-02 3.56085256236E-02 3.59663972557E-02 3.63278655575E-02 3.66929666762E-02 3.70617371221E-02 3.74342137726E-02 3.78104338757E-02 3.81904350537E-02 3.85742553070E-02 3.89619330180E-02 3.93535069547E-02 3.97490162749E-02 4.01485005299E-02 4.05519996684E-02 4.09595540407E-02 4.13712044025E-02 4.17869919192E-02 4.22069581700E-02 4.26311451517E-02 4.30595952835E-02 4.34923514106E-02 4.39294568092E-02 4.43709551900E-02 4.48168907034E-02 4.52673079431E-02 4.57222519514E-02 4.61817682230E-02 4.66459027099E-02 4.71147018259E-02 4.75882124514E-02 4.80664819378E-02 4.85495581124E-02 4.90374892833E-02 4.95303242440E-02 5.00281122783E-02 5.05309031656E-02 5.10387471854E-02 5.15516951223E-02 5.20697982718E-02 5.25931084445E-02 5.31216779718E-02 5.36555597112E-02 5.41948070513E-02 5.47394739173E-02 5.52896147762E-02 5.58452846428E-02 5.64065390843E-02 5.69734342267E-02 5.75460267601E-02 5.81243739440E-02 5.87085336138E-02 5.92985641859E-02 5.98945246638E-02 6.04964746441E-02 6.11044743223E-02 6.17185844988E-02 6.23388665852E-02 6.29653826103E-02 6.35981952260E-02 6.42373677143E-02 6.48829639929E-02 6.55350486219E-02 6.61936868104E-02 6.68589444228E-02 6.75308879853E-02 6.82095846929E-02 6.88951024158E-02 6.95875097064E-02 7.02868758059E-02 7.09932706516E-02 7.17067648835E-02 7.24274298516E-02 7.31553376231E-02 7.38905609893E-02 7.46331734732E-02 7.53832493366E-02 7.61408635878E-02 7.69060919888E-02 7.76790110631E-02 7.84596981032E-02 7.92482311785E-02 8.00446891430E-02 8.08491516431E-02 8.16616991257E-02 8.24824128463E-02 8.33113748769E-02 8.41486681144E-02 8.49943762889E-02 8.58485839718E-02 8.67113765846E-02 8.75828404074E-02 8.84630625872E-02 8.93521311470E-02 9.02501349943E-02 9.11571639304E-02 9.20733086588E-02 9.29986607948E-02 9.39333128744E-02 9.48773583636E-02 9.58308916676E-02 9.67940081407E-02 9.77668040953E-02 9.87493768117E-02 9.97418245481E-02 1.00744246550E-01 1.01756743061E-01 1.02779415330E-01 1.03812365627E-01 1.04855697247E-01 1.05909514524E-01 1.06973922841E-01 1.08049028639E-01 1.09134939430E-01 1.10231763806E-01 1.11339611451E-01 1.12458593149E-01 1.13588820800E-01 1.14730407428E-01 1.15883467192E-01 1.17048115400E-01 1.18224468516E-01 1.19412644178E-01 1.20612761204E-01 1.21824939607E-01 1.23049300605E-01 1.24285966636E-01 1.25535061367E-01 1.26796709708E-01 1.28071037827E-01 1.29358173155E-01 1.30658244409E-01 1.31971381597E-01 1.33297716032E-01 1.34637380350E-01 1.35990508518E-01 1.37357235851E-01 1.38737699021E-01 1.40132036077E-01 1.41540386454E-01 1.42962890987E-01 1.44399691928E-01 1.45850932959E-01 1.47316759204E-01 1.48797317249E-01 1.50292755149E-01 1.51803222450E-01 1.53328870199E-01 1.54869850963E-01 1.56426318842E-01 1.57998429483E-01 1.59586340098E-01 1.61190209480E-01 1.62810198018E-01 1.64446467711E-01 1.66099182188E-01 1.67768506721E-01 1.69454608245E-01 1.71157655371E-01 1.72877818406E-01 1.74615269366E-01 1.76370181998E-01 1.78142731796E-01 1.79933096016E-01 1.81741453694E-01 1.83567985670E-01 1.85412874597E-01 1.87276304967E-01 1.89158463123E-01 1.91059537282E-01 1.92979717555E-01 1.94919195960E-01 1.96878166448E-01 1.98856824916E-01 2.00855369232E-01 2.02873999252E-01 2.04912916842E-01 2.06972325894E-01 2.09052432351E-01 2.11153444225E-01 2.13275571620E-01 2.15419026750E-01 2.17584023962E-01 2.19770779758E-01 2.21979512814E-01 2.24210444007E-01 2.26463796432E-01 2.28739795424E-01 2.31038668587E-01 2.33360645809E-01 2.35705959291E-01 2.38074843564E-01 2.40467535521E-01 2.42884274431E-01 2.45325301971E-01 2.47790862246E-01 2.50281201813E-01 2.52796569710E-01 2.55337217474E-01 2.57903399172E-01 2.60495371425E-01 2.63113393433E-01 2.65757726999E-01 2.68428636559E-01 2.71126389207E-01 2.73851254719E-01 2.76603505585E-01 2.79383417032E-01 2.82191267054E-01 2.85027336438E-01 2.87891908792E-01 2.90785270578E-01 2.93707711133E-01 2.96659522704E-01 2.99641000474E-01 3.02652442594E-01 3.05694150211E-01 3.08766427497E-01 3.11869581683E-01 3.15003923087E-01 3.18169765147E-01 3.21367424448E-01 3.24597220759E-01 3.27859477062E-01 3.31154519587E-01 3.34482677839E-01 3.37844284638E-01 3.41239676148E-01 3.44669191909E-01 3.48133174876E-01 3.51631971451E-01 3.55165931516E-01 3.58735408471E-01 3.62340759265E-01 3.65982344437E-01 3.69660528148E-01 3.73375678221E-01 3.77128166172E-01 3.80918367254E-01 3.84746660490E-01 3.88613428713E-01 3.92519058603E-01 3.96463940726E-01 4.00448469573E-01 4.04473043601E-01 4.08538065270E-01 4.12643941086E-01 4.16791081640E-01 4.20979901650E-01 4.25210820001E-01 4.29484259788E-01 4.33800648359E-01 4.38160417356E-01 4.42564002760E-01 4.47011844933E-01 4.51504388663E-01 4.56042083208E-01 4.60625382342E-01 4.65254744398E-01 4.69930632316E-01 4.74653513689E-01 4.79423860808E-01 4.84242150713E-01 4.89108865237E-01 4.94024491055E-01 4.98989519734E-01 5.04004447781E-01 5.09069776692E-01 5.14186013005E-01 5.19353668348E-01 5.24573259491E-01 5.29845308397E-01 5.35170342275E-01 5.40548893633E-01 5.45981500331E-01 5.51468705635E-01 5.57011058268E-01 5.62609112471E-01 5.68263428055E-01 5.73974570454E-01 5.79743110790E-01 5.85569625919E-01 5.91454698499E-01 5.97398917041E-01 6.03402875974E-01 6.09467175696E-01 6.15592422644E-01 6.21779229348E-01 6.28028214492E-01 6.34340002981E-01 6.40715225999E-01 6.47154521074E-01 6.53658532140E-01 6.60227909604E-01 6.66863310409E-01 6.73565398101E-01 6.80334842894E-01 6.87172321738E-01 6.94078518388E-01 7.01054123467E-01 7.08099834543E-01 7.15216356192E-01 7.22404400073E-01 7.29664684996E-01 7.36997936996E-01 7.44404889403E-01 7.51886282920E-01 7.59442865692E-01 7.67075393383E-01 7.74784629253E-01 7.82571344231E-01 7.90436316996E-01 7.98380334051E-01 8.06404189805E-01 8.14508686650E-01 8.22694635042E-01 8.30962853583E-01 8.39314169103E-01 8.47749416738E-01 8.56269440022E-01 8.64875090963E-01 8.73567230134E-01 8.82346726757E-01 8.91214458787E-01 9.00171313005E-01 9.09218185105E-01 9.18355979782E-01 9.27585610821E-01 9.36908001195E-01 9.46324083149E-01 9.55834798301E-01 9.65441097728E-01 9.75143942071E-01 9.84944301619E-01 9.94843156419E-01 -5.01093999843E+00 -5.01093960017E+00 -5.01093919386E+00 -5.01093877939E+00 -5.01093835658E+00 -5.01093792518E+00 -5.01093748504E+00 -5.01093703600E+00 -5.01093657790E+00 -5.01093611054E+00 -5.01093563374E+00 -5.01093514731E+00 -5.01093465106E+00 -5.01093414477E+00 -5.01093362827E+00 -5.01093310133E+00 -5.01093256375E+00 -5.01093201530E+00 -5.01093145578E+00 -5.01093088496E+00 -5.01093030260E+00 -5.01092970849E+00 -5.01092910237E+00 -5.01092848401E+00 -5.01092785316E+00 -5.01092720956E+00 -5.01092655297E+00 -5.01092588311E+00 -5.01092519972E+00 -5.01092450253E+00 -5.01092379126E+00 -5.01092306561E+00 -5.01092232532E+00 -5.01092157007E+00 -5.01092079956E+00 -5.01092001349E+00 -5.01091921155E+00 -5.01091839340E+00 -5.01091755872E+00 -5.01091670720E+00 -5.01091583847E+00 -5.01091495219E+00 -5.01091404801E+00 -5.01091312557E+00 -5.01091218450E+00 -5.01091122442E+00 -5.01091024494E+00 -5.01090924569E+00 -5.01090822625E+00 -5.01090718622E+00 -5.01090612518E+00 -5.01090504271E+00 -5.01090393839E+00 -5.01090281175E+00 -5.01090166236E+00 -5.01090048976E+00 -5.01089929347E+00 -5.01089807302E+00 -5.01089682792E+00 -5.01089555767E+00 -5.01089426177E+00 -5.01089293969E+00 -5.01089159092E+00 -5.01089021490E+00 -5.01088881109E+00 -5.01088737892E+00 -5.01088591784E+00 -5.01088442725E+00 -5.01088290655E+00 -5.01088135513E+00 -5.01087977238E+00 -5.01087815767E+00 -5.01087651036E+00 -5.01087482977E+00 -5.01087311524E+00 -5.01087136609E+00 -5.01086958160E+00 -5.01086776108E+00 -5.01086590379E+00 -5.01086400900E+00 -5.01086207595E+00 -5.01086010386E+00 -5.01085809193E+00 -5.01085603937E+00 -5.01085394537E+00 -5.01085180909E+00 -5.01084962965E+00 -5.01084740621E+00 -5.01084513788E+00 -5.01084282373E+00 -5.01084046285E+00 -5.01083805430E+00 -5.01083559711E+00 -5.01083309031E+00 -5.01083053288E+00 -5.01082792381E+00 -5.01082526206E+00 -5.01082254656E+00 -5.01081977623E+00 -5.01081694996E+00 -5.01081406663E+00 -5.01081112508E+00 -5.01080812413E+00 -5.01080506259E+00 -5.01080193923E+00 -5.01079875281E+00 -5.01079550205E+00 -5.01079218566E+00 -5.01078880231E+00 -5.01078535065E+00 -5.01078182931E+00 -5.01077823687E+00 -5.01077457190E+00 -5.01077083294E+00 -5.01076701849E+00 -5.01076312704E+00 -5.01075915702E+00 -5.01075510686E+00 -5.01075097493E+00 -5.01074675959E+00 -5.01074245916E+00 -5.01073807192E+00 -5.01073359611E+00 -5.01072902995E+00 -5.01072437162E+00 -5.01071961925E+00 -5.01071477096E+00 -5.01070982481E+00 -5.01070477882E+00 -5.01069963098E+00 -5.01069437923E+00 -5.01068902149E+00 -5.01068355561E+00 -5.01067797941E+00 -5.01067229067E+00 -5.01066648712E+00 -5.01066056644E+00 -5.01065452628E+00 -5.01064836422E+00 -5.01064207780E+00 -5.01063566452E+00 -5.01062912183E+00 -5.01062244711E+00 -5.01061563770E+00 -5.01060869088E+00 -5.01060160389E+00 -5.01059437391E+00 -5.01058699805E+00 -5.01057947337E+00 -5.01057179686E+00 -5.01056396549E+00 -5.01055597612E+00 -5.01054782556E+00 -5.01053951057E+00 -5.01053102784E+00 -5.01052237400E+00 -5.01051354558E+00 -5.01050453908E+00 -5.01049535091E+00 -5.01048597742E+00 -5.01047641486E+00 -5.01046665942E+00 -5.01045670724E+00 -5.01044655434E+00 -5.01043619669E+00 -5.01042563016E+00 -5.01041485055E+00 -5.01040385356E+00 -5.01039263483E+00 -5.01038118989E+00 -5.01036951418E+00 -5.01035760307E+00 -5.01034545180E+00 -5.01033305557E+00 -5.01032040943E+00 -5.01030750836E+00 -5.01029434722E+00 -5.01028092080E+00 -5.01026722375E+00 -5.01025325064E+00 -5.01023899590E+00 -5.01022445387E+00 -5.01020961879E+00 -5.01019448476E+00 -5.01017904576E+00 -5.01016329568E+00 -5.01014722826E+00 -5.01013083712E+00 -5.01011411576E+00 -5.01009705754E+00 -5.01007965569E+00 -5.01006190331E+00 -5.01004379338E+00 -5.01002531869E+00 -5.01000647193E+00 -5.00998724564E+00 -5.00996763219E+00 -5.00994762380E+00 -5.00992721255E+00 -5.00990639036E+00 -5.00988514899E+00 -5.00986348003E+00 -5.00984137489E+00 -5.00981882482E+00 -5.00979582092E+00 -5.00977235407E+00 -5.00974841501E+00 -5.00972399425E+00 -5.00969908215E+00 -5.00967366886E+00 -5.00964774435E+00 -5.00962129837E+00 -5.00959432047E+00 -5.00956680002E+00 -5.00953872614E+00 -5.00951008775E+00 -5.00948087356E+00 -5.00945107205E+00 -5.00942067147E+00 -5.00938965982E+00 -5.00935802490E+00 -5.00932575424E+00 -5.00929283514E+00 -5.00925925462E+00 -5.00922499949E+00 -5.00919005625E+00 -5.00915441117E+00 -5.00911805022E+00 -5.00908095912E+00 -5.00904312330E+00 -5.00900452789E+00 -5.00896515774E+00 -5.00892499739E+00 -5.00888403109E+00 -5.00884224278E+00 -5.00879961607E+00 -5.00875613425E+00 -5.00871178029E+00 -5.00866653683E+00 -5.00862038615E+00 -5.00857331020E+00 -5.00852529057E+00 -5.00847630849E+00 -5.00842634481E+00 -5.00837538003E+00 -5.00832339425E+00 -5.00827036718E+00 -5.00821627815E+00 -5.00816110608E+00 -5.00810482947E+00 -5.00804742639E+00 -5.00798887452E+00 -5.00792915108E+00 -5.00786823284E+00 -5.00780609614E+00 -5.00774271683E+00 -5.00767807034E+00 -5.00761213158E+00 -5.00754487498E+00 -5.00747627449E+00 -5.00740630354E+00 -5.00733493507E+00 -5.00726214146E+00 -5.00718789459E+00 -5.00711216579E+00 -5.00703492581E+00 -5.00695614488E+00 -5.00687579264E+00 -5.00679383813E+00 -5.00671024981E+00 -5.00662499554E+00 -5.00653804255E+00 -5.00644935744E+00 -5.00635890619E+00 -5.00626665413E+00 -5.00617256590E+00 -5.00607660548E+00 -5.00597873619E+00 -5.00587892062E+00 -5.00577712064E+00 -5.00567329744E+00 -5.00556741143E+00 -5.00545942228E+00 -5.00534928891E+00 -5.00523696946E+00 -5.00512242127E+00 -5.00500560087E+00 -5.00488646401E+00 -5.00476496555E+00 -5.00464105954E+00 -5.00451469916E+00 -5.00438583669E+00 -5.00425442357E+00 -5.00412041027E+00 -5.00398374637E+00 -5.00384438050E+00 -5.00370226033E+00 -5.00355733257E+00 -5.00340954293E+00 -5.00325883611E+00 -5.00310515579E+00 -5.00294844459E+00 -5.00278864412E+00 -5.00262569485E+00 -5.00245953619E+00 -5.00229010643E+00 -5.00211734273E+00 -5.00194118108E+00 -5.00176155632E+00 -5.00157840208E+00 -5.00139165078E+00 -5.00120123361E+00 -5.00100708052E+00 -5.00080912017E+00 -5.00060727993E+00 -5.00040148585E+00 -5.00019166264E+00 -4.99997773367E+00 -4.99975962090E+00 -4.99953724490E+00 -4.99931052479E+00 -4.99907937826E+00 -4.99884372153E+00 -4.99860346928E+00 -4.99835853470E+00 -4.99810882941E+00 -4.99785426347E+00 -4.99759474531E+00 -4.99733018175E+00 -4.99706047797E+00 -4.99678553742E+00 -4.99650526189E+00 -4.99621955140E+00 -4.99592830420E+00 -4.99563141676E+00 -4.99532878372E+00 -4.99502029785E+00 -4.99470585004E+00 -4.99438532927E+00 -4.99405862254E+00 -4.99372561489E+00 -4.99338618932E+00 -4.99304022681E+00 -4.99268760622E+00 -4.99232820431E+00 -4.99196189565E+00 -4.99158855264E+00 -4.99120804544E+00 -4.99082024192E+00 -4.99042500764E+00 -4.99002220581E+00 -4.98961169724E+00 -4.98919334029E+00 -4.98876699083E+00 -4.98833250222E+00 -4.98788972520E+00 -4.98743850792E+00 -4.98697869583E+00 -4.98651013164E+00 -4.98603265529E+00 -4.98554610387E+00 -4.98505031160E+00 -4.98454510969E+00 -4.98403032638E+00 -4.98350578682E+00 -4.98297131301E+00 -4.98242672372E+00 -4.98187183447E+00 -4.98130645740E+00 -4.98073040122E+00 -4.98014347115E+00 -4.97954546878E+00 -4.97893619206E+00 -4.97831543514E+00 -4.97768298834E+00 -4.97703863800E+00 -4.97638216641E+00 -4.97571335172E+00 -4.97503196778E+00 -4.97433778407E+00 -4.97363056557E+00 -4.97291007260E+00 -4.97217606077E+00 -4.97142828075E+00 -4.97066647818E+00 -4.96989039352E+00 -4.96909976189E+00 -4.96829431288E+00 -4.96747377040E+00 -4.96663785250E+00 -4.96578627119E+00 -4.96491873221E+00 -4.96403493485E+00 -4.96313457174E+00 -4.96221732856E+00 -4.96128288391E+00 -4.96033090896E+00 -4.95936106721E+00 -4.95837301424E+00 -4.95736639742E+00 -4.95634085558E+00 -4.95529601870E+00 -4.95423150758E+00 -4.95314693349E+00 -4.95204189780E+00 -4.95091599162E+00 -4.94976879532E+00 -4.94859987821E+00 -4.94740879803E+00 -4.94619510050E+00 -4.94495831882E+00 -4.94369797318E+00 -4.94241357026E+00 -4.94110460258E+00 -4.93977054798E+00 -4.93841086901E+00 -4.93702501228E+00 -4.93561240775E+00 -4.93417246812E+00 -4.93270458800E+00 -4.93120814321E+00 -4.92968248996E+00 -4.92812696402E+00 -4.92654087987E+00 -4.92492352975E+00 -4.92327418275E+00 -4.92159208381E+00 -4.91987645271E+00 -4.91812648298E+00 -4.91634134078E+00 -4.91452016379E+00 -4.91266205994E+00 -4.91076610620E+00 -4.90883134726E+00 -4.90685679420E+00 -4.90484142305E+00 -4.90278417338E+00 -4.90068394673E+00 -4.89853960512E+00 -4.89634996936E+00 -4.89411381741E+00 -4.89182988265E+00 -4.88949685207E+00 -4.88711336439E+00 -4.88467800821E+00 -4.88218931999E+00 -4.87964578203E+00 -4.87704582035E+00 -4.87438780254E+00 -4.87167003559E+00 -4.86889076350E+00 -4.86604816504E+00 -4.86314035126E+00 -4.86016536309E+00 -4.85712116876E+00 -4.85400566122E+00 -4.85081665552E+00 -4.84755188609E+00 -4.84420900399E+00 -4.84078557408E+00 -4.83727907218E+00 -4.83368688217E+00 -4.83000629302E+00 -4.82623449583E+00 -4.82236858074E+00 -4.81840553394E+00 -4.81434223455E+00 -4.81017545150E+00 -4.80590184042E+00 -4.80151794050E+00 -4.79702017134E+00 -4.79240482985E+00 -4.78766808705E+00 -4.78280598505E+00 -4.77781443396E+00 -4.77268920880E+00 -4.76742594659E+00 -4.76202014343E+00 -4.75646715160E+00 -4.75076217688E+00 -4.74490027587E+00 -4.73887635347E+00 -4.73268516050E+00 -4.72632129143E+00 -4.71977918236E+00 -4.71305310911E+00 -4.70613718556E+00 -4.69902536225E+00 -4.69171142514E+00 -4.68418899481E+00 -4.67645152577E+00 -4.66849230625E+00 -4.66030445835E+00 -4.65188093842E+00 -4.64321453810E+00 -4.63429788558E+00 -4.62512344754E+00 -4.61568353145E+00 -4.60597028859E+00 -4.59597571751E+00 -4.58569166822E+00 -4.57510984706E+00 -4.56422182224E+00 -4.55301903020E+00 -4.54149278272E+00 -4.52963427492E+00 -4.51743459420E+00 -4.50488473005E+00 -4.49197558491E+00 -4.47869798614E+00 -4.46504269898E+00 -4.45100044074E+00 -4.43656189625E+00 -4.42171773443E+00 -4.40645862638E+00 -4.39077526466E+00 -4.37465838413E+00 -4.35809878419E+00 -4.34108735264E+00 -4.32361509101E+00 -4.30567314166E+00 -4.28725281643E+00 -4.26834562715E+00 -4.24894331777E+00 -4.22903789842E+00 -4.20862168125E+00 -4.18768731811E+00 -4.16622784017E+00 -4.14423669937E+00 -4.12170781184E+00 -4.09863560318E+00 -4.07501505560E+00 -4.05084175697E+00 -4.02611195169E+00 -4.00082259328E+00 -3.97497139871E+00 -3.94855690439E+00 -3.92157852361E+00 -3.89403660541E+00 -3.86593249474E+00 -3.83726859364E+00 -3.80804842336E+00 -3.77827668718E+00 -3.74795933359E+00 -3.71710361965E+00 -3.68571817414E+00 -3.65381306024E+00 -3.62139983722E+00 -3.58849162076E+00 -3.55510314146E+00 -3.52125080092E+00 -3.48695272492E+00 -3.45222881294E+00 -3.41710078339E+00 -3.38159221386E+00 -3.34572857549E+00 -3.30953726059E+00 -3.27304760263E+00 -3.23629088758E+00 -3.19930035553E+00 -3.16211119133E+00 -3.12476050328E+00 -3.08728728838E+00 -3.04973238291E+00 -3.01213839681E+00 -2.97454963064E+00 -2.93701197328E+00 -2.89957277908E+00 -2.86228072273E+00 -2.82518563022E+00 -2.78833828439E+00 -2.75179020336E+00 -2.71559339030E+00 -2.67980005319E+00 -2.64446229303E+00 -2.60963175942E+00 -2.57535927255E+00 -2.54169441078E+00 -2.50868506362E+00 -2.47637695012E+00 -2.44481310339E+00 -2.41403332252E+00 -2.38407359420E+00 -2.35496548700E+00 -2.32673552282E+00 -2.29940453108E+00 -2.27298699315E+00 -2.24749038624E+00 -2.22291453832E+00 -2.19925100838E+00 -2.17648250925E+00 -2.15458239380E+00 -2.13351422951E+00 -2.11323149115E+00 -2.09367740641E+00 -2.07478499606E+00 -2.05647735678E+00 -2.03866824323E+00 -2.02126301498E+00 -2.00416002434E+00 -1.98725253323E+00 -1.97043126033E+00 -1.95358767544E+00 -1.93661817480E+00 -1.91942929125E+00 -1.90194411469E+00 -1.88411012388E+00 -1.86590865876E+00 -1.84736629469E+00 -1.82859992423E+00 -1.80993114495E+00 -1.79170076069E+00 -1.77384083810E+00 -1.75619082056E+00 -1.73871642257E+00 -1.72141589664E+00 -1.70428751266E+00 -1.68732955776E+00 -1.67054033615E+00 -1.65391816891E+00 -1.63746139376E+00 -1.62116836488E+00 -1.60503745292E+00 -1.58906704472E+00 -1.57325554318E+00 -1.55760136710E+00 -1.54210295100E+00 -1.52675874499E+00 -1.51156721458E+00 -1.49652684056E+00 -1.48163611884E+00 -1.46689356028E+00 -1.45229769058E+00 -1.43784705007E+00 -1.42354019365E+00 -1.40937569057E+00 -1.39535212431E+00 -1.38146809248E+00 -1.36772220660E+00 -1.35411309203E+00 -1.34063938782E+00 -1.32729974653E+00 -1.31409283416E+00 -1.30101732997E+00 -1.28807192635E+00 -1.27525532874E+00 -1.26256625542E+00 -1.25000343745E+00 -1.23756561853E+00 -1.22525155483E+00 -1.21306001494E+00 -1.20098977967E+00 -1.18903964200E+00 -1.17720840690E+00 -1.16549489124E+00 -1.15389792368E+00 -1.14241634453E+00 -1.13104900566E+00 -1.11979477035E+00 -1.10865251323E+00 -1.09762112011E+00 -1.08669948791E+00 -1.07588652452E+00 -1.06518114872E+00 -1.05457915672E+00 -1.04408317680E+00 -1.03369829415E+00 -1.02341625452E+00 -1.01323314333E+00 -1.00315135425E+00 -9.93169879079E-01 -9.83287719670E-01 -9.73503887802E-01 -9.63817405089E-01 -9.54227302879E-01 -9.44732622160E-01 -9.35332413463E-01 -9.26025736767E-01 -9.16811661409E-01 -9.07689265984E-01 -8.98657638260E-01 -8.89715875084E-01 -8.80863082291E-01 -8.72098374616E-01 -8.63420875608E-01 -8.54829717538E-01 -8.46324041315E-01 -8.37902996400E-01 -8.29565740721E-01 -8.21311440590E-01 -8.13139270617E-01 -8.05048413631E-01 -7.97038060595E-01 -7.89107410528E-01 -7.81255670422E-01 -7.73482055166E-01 -7.65785787464E-01 -7.58166097760E-01 -7.50622224158E-01 -7.43153412350E-01 -7.35758915535E-01 -7.28437994348E-01 -7.21189916784E-01 -7.14013958124E-01 -7.06909400865E-01 -6.99875534643E-01 -6.92911656166E-01 -6.86017069141E-01 -6.79191084205E-01 -6.72433018853E-01 -6.65742197374E-01 -6.59117950777E-01 -6.52559616728E-01 -6.46066539480E-01 -6.39638069810E-01 -6.33273564951E-01 -6.26972388530E-01 -6.20733910498E-01 -6.14557507074E-01 -6.08442560678E-01 -6.02388459866E-01 -5.96394599276E-01 -5.90460379559E-01 -5.84585207327E-01 -5.78768495084E-01 -5.73009661175E-01 -5.67308129724E-01 -5.61663330577E-01 -5.56074699245E-01 -5.50541676847E-01 -5.45063710055E-01 -5.39640251040E-01 -5.34270757415E-01 -5.28954692182E-01 -5.23691523680E-01 -5.18480725531E-01 -5.13321776587E-01 -5.08214160881E-01 -5.03157367575E-01 -4.98150890908E-01 -4.93194230147E-01 -4.88286889539E-01 -4.83428378260E-01 -4.78618210369E-01 -4.73855904758E-01 -4.69140985104E-01 -4.64472979825E-01 -4.59851422031E-01 -4.55275849479E-01 -4.50745804526E-01 -4.46260834087E-01 -4.41820489585E-01 -4.37424326912E-01 -4.33071906381E-01 -4.28762792684E-01 -4.24496554849E-01 -4.20272766196E-01 -4.16091004296E-01 -4.11950850927E-01 -4.07851892033E-01 -4.03793717684E-01 -3.99775922032E-01 -3.95798103273E-01 -3.91859863607E-01 -3.87960809194E-01 -3.84100550119E-01 -3.80278700351E-01 -3.76494877705E-01 -3.72748703800E-01 -3.69039804026E-01 -3.65367807504E-01 -3.61732347046E-01 -3.58133059124E-01 -3.54569583827E-01 -3.51041564829E-01 -3.47548649353E-01 -3.44090488132E-01 -3.40666735376E-01 -3.37277048739E-01 -3.33921089282E-01 -3.30598521440E-01 -3.27309012985E-01 -3.24052235001E-01 -3.20827861839E-01 -3.17635571096E-01 -3.14475043575E-01 -3.11345963254E-01 -3.08248017257E-01 -3.05180895822E-01 -3.02144292267E-01 -2.99137902961E-01 -2.96161427296E-01 -2.93214567654E-01 -2.90297029375E-01 -2.87408520735E-01 -2.84548752908E-01 -2.81717439944E-01 -2.78914298735E-01 -2.76139048992E-01 -2.73391413212E-01 -2.70671116654E-01 -2.67977887309E-01 -2.65311455873E-01 -2.62671555724E-01 -2.60057922887E-01 -2.57470296019E-01 -2.54908416371E-01 -2.52372027771E-01 -2.49860876594E-01 -2.47374711740E-01 -2.44913284603E-01 -2.42476349054E-01 -2.40063661408E-01 -2.37674980409E-01 -2.35310067197E-01 -2.32968685289E-01 -2.30650600556E-01 -2.28355581195E-01 -2.26083397712E-01 -2.23833822895E-01 -2.21606631791E-01 -2.19401601686E-01 -2.17218512080E-01 -2.15057144670E-01 -2.12917283320E-01 -2.10798714048E-01 -2.08701224999E-01 -2.06624606425E-01 -2.04568650666E-01 -2.02533152127E-01 -2.00517907259E-01 -1.98522714537E-01 -1.96547374442E-01 -1.94591689438E-01 -1.92655463957E-01 -1.90738504375E-01 -1.88840618994E-01 -1.86961618023E-01 -1.85101313560E-01 -1.83259519573E-01 -1.81436051879E-01 -1.79630728129E-01 -1.77843367787E-01 -1.76073792115E-01 -1.74321824151E-01 -1.72587288695E-01 -1.70870012289E-01 -1.69169823201E-01 -1.67486551411E-01 -1.65820028585E-01 -1.64170088068E-01 -1.62536564861E-01 -1.60919295608E-01 -1.59318118579E-01 -1.57732873642E-01 -1.56163402232E-01 -1.54609547617E-01 -1.53071090567E-01 -1.51548007767E-01 -1.50040079897E-01 -1.48547156157E-01 -1.47069087257E-01 -1.45605725389E-01 -1.44156924214E-01 -1.42722538852E-01 -1.41302425863E-01 -1.39896443234E-01 -1.38504450366E-01 -1.37126308058E-01 -1.35761878495E-01 -1.34411025234E-01 -1.33073613187E-01 -1.31749508612E-01 -1.30438579098E-01 -1.29140693550E-01 -1.27855722180E-01 -1.26583536488E-01 -1.25324009255E-01 -1.24077014528E-01 -1.22842427606E-01 -1.21620125028E-01 -1.20409984565E-01 -1.19211885200E-01 -1.18025707123E-01 -1.16851331716E-01 -1.15688641538E-01 -1.14537520322E-01 -1.13397852953E-01 -1.12269525463E-01 -1.11152425020E-01 -1.10046439912E-01 -1.08951459539E-01 -1.07867374404E-01 -1.06794076095E-01 -1.05731457284E-01 -1.04679411706E-01 -1.03637834156E-01 -1.02606620476E-01 -1.01585667544E-01 -1.00574873263E-01 -9.95741365538E-02 -9.85833573408E-02 -9.76024365457E-02 -9.66312760756E-02 -9.56697788136E-02 -9.47178486092E-02 -9.37753902687E-02 -9.28423095452E-02 -9.19185131302E-02 -9.10039086430E-02 -9.00984046225E-02 -8.92019105176E-02 -8.83143366780E-02 -8.74355943458E-02 -8.65655956458E-02 -8.57042535775E-02 -8.48514820060E-02 -8.40071956534E-02 -8.31713100904E-02 -8.23437417277E-02 -8.15244078078E-02 -8.07132263966E-02 -7.99101163753E-02 -7.91149974323E-02 -7.83277900549E-02 -7.75484155218E-02 -7.67767958949E-02 -7.60128540115E-02 -7.52565134769E-02 -7.45076986563E-02 -7.37663346677E-02 -7.30323473741E-02 -7.23056633760E-02 -7.15862100046E-02 -7.08739153138E-02 -7.01687080735E-02 -6.94705177626E-02 -6.87792745613E-02 -6.80949093448E-02 -6.74173536760E-02 -6.67465397988E-02 -6.60824006311E-02 -6.54248697586E-02 -6.47738814275E-02 -6.41293705386E-02 -6.34912726402E-02 -6.28595239220E-02 -6.22340612085E-02 -6.16148219530E-02 -6.10017442311E-02 -6.03947667344E-02 -5.97938287647E-02 -5.91988702277E-02 -5.86098316271E-02 -5.80266540585E-02 -5.74492792036E-02 -5.68776493245E-02 -5.63117072578E-02 -5.57513964087E-02 -5.51966607457E-02 -5.46474447948E-02 -5.41036936339E-02 -5.35653528875E-02 -5.30323687210E-02 -5.25046878355E-02 -5.19822574626E-02 -5.14650253588E-02 -5.09529398004E-02 -5.04459495784E-02 -4.99440039934E-02 -4.94470528504E-02 -4.89550464540E-02 -4.84679356029E-02 -4.79856715859E-02 -4.75082061759E-02 -4.70354916262E-02 -4.65674806648E-02 -4.61041264903E-02 -4.56453827669E-02 -4.51912036198E-02 -4.47415436307E-02 -4.42963578333E-02 -4.38556017085E-02 -4.34192311805E-02 -4.29872026118E-02 -4.25594727991E-02 -4.21359989692E-02 -4.17167387743E-02 -4.13016502881E-02 -4.08906920013E-02 -4.04838228178E-02 -4.00810020503E-02 -3.96821894164E-02 -3.92873450345E-02 -3.88964294199E-02 -3.85094034806E-02 -3.81262285137E-02 -3.77468662015E-02 -3.73712786073E-02 -3.69994281722E-02 -3.66312777107E-02 -3.62667904075E-02 -3.59059298136E-02 -3.55486598425E-02 -3.51949447671E-02 -3.48447492155E-02 -3.44980381678E-02 -3.41547769527E-02 -3.38149312438E-02 -3.34784670562E-02 -3.31453507431E-02 -3.28155489928E-02 -3.24890288247E-02 -3.21657575866E-02 -3.18457029510E-02 -3.15288329123E-02 -3.12151157831E-02 -3.09045201915E-02 -3.05970150777E-02 -3.02925696909E-02 -2.99911535863E-02 -2.96927366221E-02 -2.93972889563E-02 -2.91047810438E-02 -2.88151836338E-02 -2.85284677661E-02 -2.82446047689E-02 -2.79635662558E-02 -2.76853241226E-02 -2.74098505448E-02 -2.71371179750E-02 -2.68670991396E-02 -2.65997670365E-02 -2.63350949322E-02 -2.60730563594E-02 -2.58136251140E-02 -2.55567752526E-02 -2.53024810900E-02 -2.50507171966E-02 -2.48014583958E-02 -2.45546797615E-02 -2.43103566156E-02 -2.40684645257E-02 -2.38289793022E-02 -2.35918769966E-02 -2.33571338983E-02 -2.31247265329E-02 -2.28946316594E-02 -2.26668262681E-02 -2.24412875784E-02 -2.22179930361E-02 -2.19969203116E-02 -2.17780472975E-02 -2.15613521063E-02 -2.13468130683E-02 -2.11344087293E-02 -2.09241178488E-02 -2.07159193976E-02 -2.05097925556E-02 -2.03057167099E-02 -2.01036714528E-02 1 0 Beta L 629 -1.27153486665E+00 -1.28431212103E+00 -1.29721773160E+00 -1.31025298660E+00 -1.32336077396E+00 -1.33675008998E+00 -1.35021059006E+00 -1.36372623067E+00 -1.37742098316E+00 -1.39132698512E+00 -1.40525148455E+00 -1.41936695717E+00 -1.43367580861E+00 -1.44811266563E+00 -1.46256318143E+00 -1.47735404183E+00 -1.49215240071E+00 -1.50718850803E+00 -1.52228194969E+00 -1.53759409312E+00 -1.55306324961E+00 -1.56864937156E+00 -1.58442812610E+00 -1.60030820688E+00 -1.61636006803E+00 -1.63274413086E+00 -1.64900486952E+00 -1.66569323017E+00 -1.68232257259E+00 -1.69926855775E+00 -1.71633307833E+00 -1.73360523565E+00 -1.75104616918E+00 -1.76861686428E+00 -1.78639725238E+00 -1.80434189651E+00 -1.82245738395E+00 -1.84074477695E+00 -1.85932997229E+00 -1.87797507557E+00 -1.89685769832E+00 -1.91586421674E+00 -1.93515612710E+00 -1.95458004938E+00 -1.97423004478E+00 -1.99406522735E+00 -2.01408345189E+00 -2.03434582453E+00 -2.05477050662E+00 -2.07542256862E+00 -2.09628892622E+00 -2.11733686407E+00 -2.13856602593E+00 -2.16012012400E+00 -2.18174810542E+00 -2.20372292125E+00 -2.22583210684E+00 -2.24822776643E+00 -2.27082001241E+00 -2.29363870548E+00 -2.31668594949E+00 -2.33993109972E+00 -2.36346125512E+00 -2.38719071753E+00 -2.41122429497E+00 -2.43536893647E+00 -2.45989353811E+00 -2.48457568349E+00 -2.50951466751E+00 -2.53475840191E+00 -2.56022939371E+00 -2.58595374016E+00 -2.61191947654E+00 -2.63814138960E+00 -2.66466105404E+00 -2.69139090010E+00 -2.71849743313E+00 -2.74576418827E+00 -2.77337204963E+00 -2.80122616150E+00 -2.82934791004E+00 -2.85775042774E+00 -2.88645495204E+00 -2.91550945890E+00 -2.94473605576E+00 -2.97434966491E+00 -3.00421634286E+00 -3.03439294811E+00 -3.06483906595E+00 -3.09562303334E+00 -3.12672385311E+00 -3.15814168643E+00 -3.18987380577E+00 -3.22187957809E+00 -3.25427804175E+00 -3.28694981594E+00 -3.31996172362E+00 -3.35328640276E+00 -3.38701599302E+00 -3.42098413356E+00 -3.45533224021E+00 -3.49005445887E+00 -3.52507731861E+00 -3.56051665711E+00 -3.59622498520E+00 -3.63237978164E+00 -3.66886260046E+00 -3.70567902828E+00 -3.74288185676E+00 -3.78047833838E+00 -3.81843391361E+00 -3.85677632391E+00 -3.89551635679E+00 -3.93459831503E+00 -3.97410093871E+00 -4.01402751969E+00 -4.05431726113E+00 -4.09500894111E+00 -4.13615083135E+00 -4.17765030112E+00 -4.21961465368E+00 -4.26195119543E+00 -4.30472914227E+00 -4.34792867602E+00 -4.39160116191E+00 -4.43569324544E+00 -4.48019206990E+00 -4.52518207273E+00 -4.57059756206E+00 -4.61645216712E+00 -4.66279978570E+00 -4.70960467739E+00 -4.75684602621E+00 -4.80458860766E+00 -4.85280361355E+00 -4.90151654260E+00 -4.95071331630E+00 -5.00034992877E+00 -5.05054784105E+00 -5.10122845378E+00 -5.15240492341E+00 -5.20409975069E+00 -5.25629917063E+00 -5.30905526864E+00 -5.36228465407E+00 -5.41611937979E+00 -5.47041527101E+00 -5.52530473488E+00 -5.58073057780E+00 -5.63670158590E+00 -5.69324915281E+00 -5.75033079313E+00 -5.80801191232E+00 -5.86623570089E+00 -5.92508725062E+00 -5.98448016618E+00 -6.04449872839E+00 -6.10510247586E+00 -6.16632041240E+00 -6.22813236981E+00 -6.29057828235E+00 -6.35365329334E+00 -6.41732795561E+00 -6.48165709149E+00 -6.54664394110E+00 -6.61223642077E+00 -6.67851318493E+00 -6.74543375153E+00 -6.81302576017E+00 -6.88130473849E+00 -6.95025824001E+00 -7.01987127595E+00 -7.09022504027E+00 -7.16124760788E+00 -7.23297410924E+00 -7.30543961834E+00 -7.37860963305E+00 -7.45250980830E+00 -7.52713118471E+00 -7.60249390232E+00 -7.67863880263E+00 -7.75549274709E+00 -7.83315660206E+00 -7.91155803933E+00 -7.99076426697E+00 -8.07075950607E+00 -8.15151176639E+00 -8.23308443456E+00 -8.31548268680E+00 -8.39867783475E+00 -8.48271474560E+00 -8.56756862896E+00 -8.65326502179E+00 -8.73982010852E+00 -8.82723247381E+00 -8.91550394329E+00 -9.00464937779E+00 -9.09466989397E+00 -9.18559072567E+00 -9.27742565764E+00 -9.37012617162E+00 -9.46378209594E+00 -9.55834503997E+00 -9.65383567242E+00 -9.75029332638E+00 -9.84767590760E+00 -9.94604150911E+00 -1.00453599313E+01 -1.01456694302E+01 -1.02469588195E+01 -1.03492510388E+01 -1.04525494000E+01 -1.05568603661E+01 -1.06621994642E+01 -1.07685729918E+01 -1.08759903573E+01 -1.09844746348E+01 -1.10940041214E+01 -1.12046223734E+01 -1.13163275032E+01 -1.14291148956E+01 -1.15430213823E+01 -1.16580403570E+01 -1.17741739702E+01 -1.18914535661E+01 -1.20098729289E+01 -1.21294603075E+01 -1.22502085624E+01 -1.23721393199E+01 -1.24952525663E+01 -1.26195666858E+01 -1.27450946209E+01 -1.28718505726E+01 -1.29998260609E+01 -1.31290582598E+01 -1.32595335269E+01 -1.33912891114E+01 -1.35243091283E+01 -1.36586389643E+01 -1.37942480231E+01 -1.39311794018E+01 -1.40694358806E+01 -1.42090260494E+01 -1.43499644085E+01 -1.44922680027E+01 -1.46359395560E+01 -1.47809909269E+01 -1.49274480823E+01 -1.50753044759E+01 -1.52245830823E+01 -1.53753025632E+01 -1.55274480312E+01 -1.56810717774E+01 -1.58361547592E+01 -1.59927205309E+01 -1.61507898999E+01 -1.63103531615E+01 -1.64714429454E+01 -1.66340652453E+01 -1.67982322721E+01 -1.69639664692E+01 -1.71312561470E+01 -1.73001470035E+01 -1.74706283941E+01 -1.76427153861E+01 -1.78164400853E+01 -1.79917920640E+01 -1.81687867787E+01 -1.83474588592E+01 -1.85277980579E+01 -1.87098297676E+01 -1.88935600182E+01 -1.90790170317E+01 -1.92661924719E+01 -1.94551214791E+01 -1.96457988376E+01 -1.98382530966E+01 -2.00324787372E+01 -2.02285173305E+01 -2.04263453189E+01 -2.06260096683E+01 -2.08275104221E+01 -2.10308518011E+01 -2.12360663934E+01 -2.14431472879E+01 -2.16521232844E+01 -2.18630054686E+01 -2.20758010766E+01 -2.22905196921E+01 -2.25071853219E+01 -2.27258039352E+01 -2.29463913445E+01 -2.31689636181E+01 -2.33935273633E+01 -2.36200925063E+01 -2.38486792843E+01 -2.40793068869E+01 -2.43119681001E+01 -2.45466896602E+01 -2.47834799302E+01 -2.50223463608E+01 -2.52633129273E+01 -2.55063748448E+01 -2.57515603874E+01 -2.59988764822E+01 -2.62483232850E+01 -2.64999205663E+01 -2.67536807240E+01 -2.70096145313E+01 -2.72677314068E+01 -2.75280375413E+01 -2.77905453890E+01 -2.80552681464E+01 -2.83222080345E+01 -2.85913864407E+01 -2.88627942959E+01 -2.91364625646E+01 -2.94123798558E+01 -2.96905660252E+01 -2.99710175400E+01 -3.02537574175E+01 -3.05387809664E+01 -3.08260962002E+01 -3.11157123101E+01 -3.14076313009E+01 -3.17018635724E+01 -3.19984069104E+01 -3.22972678781E+01 -3.25984566823E+01 -3.29019710224E+01 -3.32078028391E+01 -3.35159770513E+01 -3.38264757992E+01 -3.41393120248E+01 -3.44544792226E+01 -3.47719770961E+01 -3.50918071556E+01 -3.54139676030E+01 -3.57384523620E+01 -3.60652640490E+01 -3.63943849923E+01 -3.67258279374E+01 -3.70595782581E+01 -3.73956239347E+01 -3.77339674301E+01 -3.80745928091E+01 -3.84174928569E+01 -3.87626569940E+01 -3.91100737687E+01 -3.94597288980E+01 -3.98116092367E+01 -4.01656988202E+01 -4.05219810983E+01 -4.08804415032E+01 -4.12410560152E+01 -4.16038070743E+01 -4.19686730684E+01 -4.23356299211E+01 -4.27046533119E+01 -4.30757187685E+01 -4.34487965142E+01 -4.38238566874E+01 -4.42008714674E+01 -4.45798053963E+01 -4.49606257181E+01 -4.53432955258E+01 -4.57277739483E+01 -4.61140285577E+01 -4.65020059533E+01 -4.68916723921E+01 -4.72829758039E+01 -4.76758685885E+01 -4.80703012846E+01 -4.84662231049E+01 -4.88635740891E+01 -4.92622967652E+01 -4.96623366831E+01 -5.00636265199E+01 -5.04660966670E+01 -5.08696901018E+01 -5.12743252673E+01 -5.16799330018E+01 -5.20864367001E+01 -5.24937552784E+01 -5.29018072726E+01 -5.33105061665E+01 -5.37197585747E+01 -5.41294794594E+01 -5.45395675008E+01 -5.49499220146E+01 -5.53604445994E+01 -5.57710237550E+01 -5.61815507441E+01 -5.65919120647E+01 -5.70019879860E+01 -5.74116550283E+01 -5.78207842190E+01 -5.82292515281E+01 -5.86369156696E+01 -5.90436397844E+01 -5.94492757360E+01 -5.98536788079E+01 -6.02566931371E+01 -6.06581609366E+01 -6.10579170705E+01 -6.14557964462E+01 -6.18516212207E+01 -6.22452149285E+01 -6.26363924440E+01 -6.30249661376E+01 -6.34107365375E+01 -6.37935073686E+01 -6.41730682178E+01 -6.45492089939E+01 -6.49217111188E+01 -6.52903519649E+01 -6.56548971367E+01 -6.60151151341E+01 -6.63707568090E+01 -6.67215789503E+01 -6.70673228335E+01 -6.74077263522E+01 -6.77425237693E+01 -6.80714356075E+01 -6.83941829656E+01 -6.87104739417E+01 -6.90200178408E+01 -6.93225062696E+01 -6.96176357510E+01 -6.99050872551E+01 -7.01845363134E+01 -7.04556549410E+01 -7.07181049633E+01 -7.09715413431E+01 -7.12156156973E+01 -7.14499652279E+01 -7.16742302727E+01 -7.18880355981E+01 -7.20910043554E+01 -7.22827494580E+01 -7.24628804461E+01 -7.26309992088E+01 -7.27866980805E+01 -7.29295697517E+01 -7.30591940789E+01 -7.31751488404E+01 -7.32770033893E+01 -7.33643275133E+01 -7.34366783855E+01 -7.34936108665E+01 -7.35346786246E+01 -7.35594257836E+01 -7.35673959628E+01 -7.35581270495E+01 -7.35311562092E+01 -7.34860139490E+01 -7.34222357298E+01 -7.33393466013E+01 -7.32368752866E+01 -7.31143517557E+01 -7.29713018532E+01 -7.28072551753E+01 -7.26217402193E+01 -7.24142928500E+01 -7.21844469252E+01 -7.19317442087E+01 -7.16557283679E+01 -7.13559535791E+01 -7.10319751949E+01 -7.06833623716E+01 -7.03096918016E+01 -6.99105498483E+01 -6.94855384281E+01 -6.90342690804E+01 -6.85563689227E+01 -6.80514840731E+01 -6.75192785133E+01 -6.69594337448E+01 -6.63716529001E+01 -6.57556663231E+01 -6.51112255332E+01 -6.44381116132E+01 -6.37361356117E+01 -6.30051388132E+01 -6.22449978787E+01 -6.14556225364E+01 -6.06369685130E+01 -5.97890242209E+01 -5.89118274331E+01 -5.80054593706E+01 -5.70700530088E+01 -5.61057944080E+01 -5.51129194848E+01 -5.40917285801E+01 -5.30425783780E+01 -5.19658928986E+01 -5.08621598890E+01 -4.97319447928E+01 -4.85758773517E+01 -4.73946724196E+01 -4.61891213498E+01 -4.49601017905E+01 -4.37085744436E+01 -4.24355970348E+01 -4.11423146735E+01 -3.98299739370E+01 -3.84999181906E+01 -3.71535967391E+01 -3.57925657293E+01 -3.44184871351E+01 -3.30331375110E+01 -3.16384077115E+01 -3.02363029870E+01 -2.88289511739E+01 -2.74185971878E+01 -2.60076078603E+01 -2.45984762421E+01 -2.31938132434E+01 -2.17963603449E+01 -2.04089756335E+01 -1.90346447772E+01 -1.76764713703E+01 -1.63376766796E+01 -1.50216000720E+01 -1.37316911908E+01 -1.24715056851E+01 -1.12447008127E+01 -1.00550278729E+01 -8.90632474190E+00 -7.80250557401E+00 -6.74754976163E+00 -5.74549421800E+00 -4.80041284446E+00 -3.91640766902E+00 -3.09758930783E+00 -2.34805875490E+00 -1.67188588368E+00 -1.07308783457E+00 -5.55606302480E-01 -1.23275277022E-01 2.20202146534E-01 4.71287805932E-01 6.26643311499E-01 6.83166600812E-01 6.38026874652E-01 4.88712064751E-01 2.33069365280E-01 -1.30647535178E-01 -6.03728670752E-01 -1.18695459083E+00 -1.88054459583E+00 -2.68409877842E+00 -3.59653793333E+00 -4.61604543216E+00 -5.74000313555E+00 -6.96492872549E+00 -8.28641112724E+00 -9.69904488859E+00 -1.11963676890E+01 -1.27707948402E+01 -1.44135585578E+01 -1.61146496774E+01 -1.78627596023E+01 -1.96452328141E+01 -2.14480215763E+01 -2.32556495329E+01 -2.50511855427E+01 -2.68162291390E+01 -2.85309075753E+01 -3.01738903964E+01 -3.17224245634E+01 -3.31523857516E+01 -3.44383591325E+01 -3.55537456318E+01 -3.64708962616E+01 -3.71612888110E+01 -3.75957348838E+01 -3.77446352445E+01 -3.75782789779E+01 -3.70671953605E+01 -3.61825598898E+01 -3.48966590529E+01 -3.31834180547E+01 -3.10189936136E+01 -2.83824369640E+01 -2.52564199035E+01 -2.16280401158E+01 -1.74896835596E+01 -1.28399560023E+01 -7.68467185663E+00 -2.03788394027E+00 4.07705204448E+00 1.06264027812E+01 1.75650024637E+01 2.48352467499E+01 3.23661863109E+01 4.00727744294E+01 4.78553393506E+01 5.55993696527E+01 6.31757243475E+01 7.04413885072E+01 7.72409491883E+01 8.34089696788E+01 8.87735018064E+01 9.31610099943E+01 9.64030353177E+01 9.83449949870E+01 9.88575759077E+01 9.78512773303E+01 9.52947445626E+01 9.12376575722E+01 8.57780123863E+01 7.88563651409E+01 7.03599746977E+01 6.01719192915E+01 4.81676614575E+01 3.42489619623E+01 1.80138652835E+01 1.97585690602E+00 -1.96630360174E-01 1.95679193160E-02 -1.94729914071E-03 1.93798574139E-04 -1.93062962078E-05 1.94870557376E-06 -1.88810411258E-07 1.56095339208E-08 -2.26541185777E-10 -1.16985319142E-08 2 0 Beta L 629 1.67326984510E+00 1.69008406916E+00 1.70706720536E+00 1.72422094905E+00 1.74146874895E+00 1.75908646415E+00 1.77679907834E+00 1.79458610017E+00 1.81260787377E+00 1.83090583641E+00 1.84923095741E+00 1.86780637286E+00 1.88663481386E+00 1.90563229404E+00 1.92465063501E+00 1.94411241042E+00 1.96358727403E+00 1.98337299272E+00 2.00323621608E+00 2.02338592644E+00 2.04374191840E+00 2.06425289673E+00 2.08501638579E+00 2.10591471309E+00 2.12703866279E+00 2.14859583640E+00 2.16999750318E+00 2.19195561401E+00 2.21384143063E+00 2.23614040117E+00 2.25859663096E+00 2.28132517635E+00 2.30427599525E+00 2.32739854043E+00 2.35079632881E+00 2.37441055184E+00 2.39824988440E+00 2.42231560047E+00 2.44677060346E+00 2.47130730599E+00 2.49615556114E+00 2.52116821406E+00 2.54655430451E+00 2.57211556215E+00 2.59797360193E+00 2.62407556575E+00 2.65041885435E+00 2.67708232781E+00 2.70396051140E+00 2.73113719560E+00 2.75859581949E+00 2.78629410307E+00 2.81423144804E+00 2.84259391853E+00 2.87105678094E+00 2.89997318892E+00 2.92906831050E+00 2.95853902948E+00 2.98826901833E+00 3.01829701889E+00 3.04862578982E+00 3.07921584675E+00 3.11017962345E+00 3.14140663823E+00 3.17303226395E+00 3.20480716242E+00 3.23707874016E+00 3.26955978861E+00 3.30237851375E+00 3.33559717479E+00 3.36911536302E+00 3.40296705039E+00 3.43713676128E+00 3.47164376624E+00 3.50654169536E+00 3.54171756831E+00 3.57738659288E+00 3.61326909620E+00 3.64959892047E+00 3.68625343041E+00 3.72326048068E+00 3.76063699980E+00 3.79841062736E+00 3.83664328843E+00 3.87510521238E+00 3.91407426140E+00 3.95337735072E+00 3.99308805187E+00 4.03315416217E+00 4.07366414982E+00 4.11459090314E+00 4.15593470950E+00 4.19769207957E+00 4.23981067323E+00 4.28244434335E+00 4.32543883046E+00 4.36888065488E+00 4.41273447552E+00 4.45711954579E+00 4.50182080503E+00 4.54702118146E+00 4.59271315618E+00 4.63880191955E+00 4.68543717000E+00 4.73242843351E+00 4.78000518374E+00 4.82801434936E+00 4.87646333154E+00 4.92542034222E+00 4.97489493974E+00 5.02484244806E+00 5.07529893219E+00 5.12627828511E+00 5.17770872008E+00 5.22969201285E+00 5.28223261494E+00 5.33525192750E+00 5.38880024060E+00 5.44293996381E+00 5.49755159764E+00 5.55277378468E+00 5.60848689589E+00 5.66478046187E+00 5.72162901225E+00 5.77909896877E+00 5.83712150098E+00 5.89568010521E+00 5.95488402667E+00 6.01464843494E+00 6.07499105748E+00 6.13598166926E+00 6.19757418386E+00 6.25974181931E+00 6.32256836264E+00 6.38601674796E+00 6.45011997413E+00 6.51486005919E+00 6.58018010505E+00 6.64623732461E+00 6.71293020055E+00 6.78027586964E+00 6.84830348832E+00 6.91699544504E+00 6.98641911675E+00 7.05646691577E+00 7.12730958307E+00 7.19876092195E+00 7.27099218041E+00 7.34392959936E+00 7.41758461278E+00 7.49199792266E+00 7.56711479777E+00 7.64301988197E+00 7.71963984800E+00 7.79708486744E+00 7.87524334801E+00 7.95422440351E+00 8.03397587805E+00 8.11453537137E+00 8.19587693769E+00 8.27805238801E+00 8.36105556963E+00 8.44484852450E+00 8.52950229717E+00 8.61502122027E+00 8.70133812465E+00 8.78855477459E+00 8.87661908232E+00 8.96556681813E+00 9.05541831387E+00 9.14615754389E+00 9.23776535940E+00 9.33034682789E+00 9.42380915995E+00 9.51819790347E+00 9.61355856937E+00 9.70984671277E+00 9.80709569269E+00 9.90529404695E+00 1.00044680011E+01 1.01046705134E+01 1.02058072227E+01 1.03080086746E+01 1.04111815387E+01 1.05154128886E+01 1.06206824739E+01 1.07269491575E+01 1.08342950193E+01 1.09427269502E+01 1.10522080474E+01 1.11627965172E+01 1.12744604336E+01 1.13872330631E+01 1.15011354750E+01 1.16161660648E+01 1.17323273413E+01 1.18496387481E+01 1.19681018883E+01 1.20877496299E+01 1.22085999419E+01 1.23305903290E+01 1.24538370981E+01 1.25782779331E+01 1.27039397163E+01 1.28308735316E+01 1.29590251576E+01 1.30884699099E+01 1.32191689579E+01 1.33511719786E+01 1.34844647085E+01 1.36190770495E+01 1.37550134703E+01 1.38922825720E+01 1.40309046315E+01 1.41708880523E+01 1.43122451625E+01 1.44550060750E+01 1.45991429348E+01 1.47447122992E+01 1.48917119443E+01 1.50401361620E+01 1.51900327749E+01 1.53413935093E+01 1.54942213715E+01 1.56485571389E+01 1.58043929984E+01 1.59617657435E+01 1.61206663702E+01 1.62811231015E+01 1.64431361741E+01 1.66067295990E+01 1.67719203572E+01 1.69387270850E+01 1.71071390739E+01 1.72772046320E+01 1.74489064037E+01 1.76222927951E+01 1.77973435344E+01 1.79741175855E+01 1.81525756505E+01 1.83327737107E+01 1.85147156548E+01 1.86984128446E+01 1.88838843129E+01 1.90711523668E+01 1.92602208275E+01 1.94511052915E+01 1.96438396200E+01 1.98384156292E+01 2.00348633234E+01 2.02332070912E+01 2.04334280191E+01 2.06355939597E+01 2.08396806219E+01 2.10457187226E+01 2.12537354859E+01 2.14637186499E+01 2.16757107042E+01 2.18897196992E+01 2.21057617196E+01 2.23238660953E+01 2.25440180062E+01 2.27662768553E+01 2.29906291746E+01 2.32170947668E+01 2.34457154347E+01 2.36764780254E+01 2.39094028260E+01 2.41445349229E+01 2.43818613753E+01 2.46214153443E+01 2.48632049308E+01 2.51072669450E+01 2.53535909214E+01 2.56022226198E+01 2.58531556080E+01 2.61064271277E+01 2.63620303493E+01 2.66200193577E+01 2.68803639981E+01 2.71431253354E+01 2.74083037316E+01 2.76759049710E+01 2.79459715124E+01 2.82184947348E+01 2.84935122056E+01 2.87710385679E+01 2.90510835062E+01 2.93336597316E+01 2.96187985995E+01 2.99065081519E+01 3.01968091511E+01 3.04897226820E+01 3.07852576127E+01 3.10834270955E+01 3.13842576004E+01 3.16877742555E+01 3.19939680488E+01 3.23028738473E+01 3.26145027861E+01 3.29288647884E+01 3.32459911714E+01 3.35658760374E+01 3.38885562481E+01 3.42140410522E+01 3.45423309508E+01 3.48734517893E+01 3.52074198845E+01 3.55442494451E+01 3.58839529342E+01 3.62265386318E+01 3.65720229071E+01 3.69204230971E+01 3.72717423233E+01 3.76260085051E+01 3.79832101653E+01 3.83433875877E+01 3.87065262841E+01 3.90726521675E+01 3.94417608869E+01 3.98138824377E+01 4.01890109596E+01 4.05671570316E+01 4.09483327291E+01 4.13325408471E+01 4.17197950069E+01 4.21100925349E+01 4.25034420786E+01 4.28998569876E+01 4.32993344453E+01 4.37018641703E+01 4.41074785072E+01 4.45161544804E+01 4.49279089402E+01 4.53427335570E+01 4.57606280424E+01 4.61815944171E+01 4.66056304135E+01 4.70327282172E+01 4.74628912484E+01 4.78960966722E+01 4.83323609713E+01 4.87716652158E+01 4.92139938410E+01 4.96593499823E+01 5.01077129781E+01 5.05590734094E+01 5.10134175123E+01 5.14707303483E+01 5.19309933261E+01 5.23941892838E+01 5.28602974085E+01 5.33292960975E+01 5.38011663018E+01 5.42758767136E+01 5.47534043699E+01 5.52337210311E+01 5.57167952561E+01 5.62025952580E+01 5.66910890279E+01 5.71822376767E+01 5.76760021670E+01 5.81723460845E+01 5.86712231028E+01 5.91725903596E+01 5.96763996009E+01 6.01825974103E+01 6.06911412512E+01 6.12019614530E+01 6.17150137071E+01 6.22302299909E+01 6.27475480109E+01 6.32669030495E+01 6.37882286108E+01 6.43114463301E+01 6.48364809951E+01 6.53632612733E+01 6.58916991482E+01 6.64217035999E+01 6.69531998391E+01 6.74860813205E+01 6.80202574661E+01 6.85556280405E+01 6.90920869619E+01 6.96295276164E+01 7.01678368063E+01 7.07068924046E+01 7.12465830258E+01 7.17867761800E+01 7.23273401553E+01 7.28681461287E+01 7.34090482952E+01 7.39499043619E+01 7.44905658290E+01 7.50308760766E+01 7.55706735920E+01 7.61097896959E+01 7.66480620475E+01 7.71853059301E+01 7.77213422985E+01 7.82559774666E+01 7.87890221034E+01 7.93202724155E+01 7.98495220556E+01 8.03765551159E+01 8.09011556848E+01 8.14230913010E+01 8.19421312274E+01 8.24580334669E+01 8.29705527226E+01 8.34794283291E+01 8.39844036930E+01 8.44852038808E+01 8.49815543156E+01 8.54731693926E+01 8.59597582090E+01 8.64410145964E+01 8.69166360670E+01 8.73862972709E+01 8.78496804720E+01 8.83064478332E+01 8.87562570944E+01 8.91987612500E+01 8.96335954920E+01 9.00603957081E+01 9.04787809443E+01 9.08883717658E+01 9.12887658246E+01 9.16795671004E+01 9.20603594357E+01 9.24307196213E+01 9.27902198864E+01 9.31384192702E+01 9.34748679336E+01 9.37991117086E+01 9.41106777968E+01 9.44090974581E+01 9.46938818436E+01 9.49645400344E+01 9.52205679095E+01 9.54614570237E+01 9.56866890862E+01 9.58957335132E+01 9.60880602394E+01 9.62631226900E+01 9.64203716807E+01 9.65592472373E+01 9.66791900487E+01 9.67796246208E+01 9.68599725971E+01 9.69196542276E+01 9.69580775789E+01 9.69746502427E+01 9.69687725850E+01 9.69398442447E+01 9.68872564738E+01 9.68104071628E+01 9.67086810032E+01 9.65814677044E+01 9.64281588822E+01 9.62481411332E+01 9.60408062361E+01 9.58055449020E+01 9.55417577445E+01 9.52488431802E+01 9.49262102695E+01 9.45732709795E+01 9.41894513326E+01 9.37741793663E+01 9.33269014885E+01 9.28470743905E+01 9.23341678464E+01 9.17876723341E+01 9.12070914047E+01 9.05919494003E+01 8.99417959165E+01 8.92562043548E+01 8.85347715081E+01 8.77771229052E+01 8.69829200539E+01 8.61518526645E+01 8.52836495281E+01 8.43780790544E+01 8.34349496605E+01 8.24541164334E+01 8.14354781774E+01 8.03789941529E+01 7.92846668931E+01 7.81525637819E+01 7.69828094310E+01 7.57755964383E+01 7.45311871277E+01 7.32499093845E+01 7.19321755099E+01 7.05784717741E+01 6.91893726426E+01 6.77655361090E+01 6.63077217535E+01 6.48167734215E+01 6.32936461159E+01 6.17393948541E+01 6.01551873058E+01 5.85422995842E+01 5.69021342684E+01 5.52362079034E+01 5.35461691646E+01 5.18337927512E+01 5.01009911567E+01 4.83498157627E+01 4.65824554497E+01 4.48012478182E+01 4.30086787316E+01 4.12073823222E+01 3.94001514580E+01 3.75899304899E+01 3.57798213502E+01 3.39730889580E+01 3.21731502330E+01 3.03835903380E+01 2.86081444186E+01 2.68507115717E+01 2.51153421207E+01 2.34062370394E+01 2.17277482284E+01 2.00843681109E+01 1.84807238095E+01 1.69215711318E+01 1.54117844491E+01 1.39563466819E+01 1.25603356109E+01 1.12289092070E+01 9.96729523852E+00 8.78076430106E+00 7.67461791215E+00 6.65416278981E+00 5.72468683474E+00 4.89143084988E+00 4.15956009657E+00 3.53413442424E+00 3.02006604538E+00 2.62208903344E+00 2.34471479195E+00 2.19218648837E+00 2.16843127494E+00 2.27701460682E+00 2.52107837368E+00 2.90328801601E+00 3.42577099453E+00 4.09005199510E+00 4.89698373614E+00 5.84667967990E+00 6.93843878648E+00 8.17066756296E+00 9.54080471617E+00 1.10452381694E+01 1.26792239955E+01 1.44368029698E+01 1.63107158785E+01 1.82923229842E+01 2.03715197274E+01 2.25366587309E+01 2.47744751149E+01 2.70700122749E+01 2.94065614878E+01 3.17656045451E+01 3.41267680900E+01 3.64677914029E+01 3.87645094494E+01 4.09908511525E+01 4.31188605790E+01 4.51187449723E+01 4.69589439752E+01 4.86062372648E+01 5.00258854264E+01 5.11818074301E+01 5.20368131838E+01 5.25528756358E+01 5.26914656407E+01 5.24139437774E+01 5.16820206030E+01 5.04582872016E+01 4.87068219183E+01 4.63938787032E+01 4.34886597471E+01 3.99641789934E+01 3.57982072033E+01 3.09743194668E+01 2.54830163514E+01 1.93229341798E+01 1.25021289817E+01 5.03941277697E+00 -3.03426602873E+00 -1.16744300044E+01 -2.08217069923E+01 -3.04005291182E+01 -4.03179624979E+01 -5.04627384450E+01 -6.07045780540E+01 -7.08939248000E+01 -8.08622301769E+01 -9.04229492259E+01 -9.93734726686E+01 -1.07498226669E+02 -1.14573251140E+02 -1.20372611522E+02 -1.24677069628E+02 -1.27285526158E+02 -1.28029829366E+02 -1.26793669137E+02 -1.23536388330E+02 -1.18322701019E+02 -1.11280086984E+02 -1.02331253145E+02 -9.13296399112E+01 -7.81233050403E+01 -6.25504652418E+01 -4.44835616164E+01 -2.34005101686E+01 -2.56702845870E+00 2.55461683120E-01 -2.54225932365E-02 2.52992651484E-03 -2.51782586737E-04 2.50825530197E-05 -2.53156209926E-06 2.45317629639E-07 -2.03028963340E-08 2.99640281602E-10 1.51253894431E-08 3 Number of nonzero Dij 1 1 -4.21433600343E-02 1 2 -3.00168022536E-02 2 2 -2.08411904985E-02 0 nqf. If not zero, Qij's inside rinner are computed using qfcoef's 1 1 0 i j (l(j)) 1.86345478544E-02 Q_int 3.57843450182E-06 3.65072134542E-06 3.72446838509E-06 3.79970511488E-06 3.87646162450E-06 3.95476861131E-06 4.03465739268E-06 4.11615991842E-06 4.19930878360E-06 4.28413724153E-06 4.37067921713E-06 4.45896932039E-06 4.54904286029E-06 4.64093585884E-06 4.73468506554E-06 4.83032797200E-06 4.92790282697E-06 5.02744865162E-06 5.12900525510E-06 5.23261325049E-06 5.33831407101E-06 5.44614998654E-06 5.55616412059E-06 5.66840046745E-06 5.78290390983E-06 5.89972023673E-06 6.01889616179E-06 6.14047934193E-06 6.26451839639E-06 6.39106292615E-06 6.52016353375E-06 6.65187184349E-06 6.78624052209E-06 6.92332329969E-06 7.06317499133E-06 7.20585151882E-06 7.35140993313E-06 7.49990843712E-06 7.65140640882E-06 7.80596442513E-06 7.96364428601E-06 8.12450903917E-06 8.28862300527E-06 8.45605180354E-06 8.62686237804E-06 8.80112302439E-06 8.97890341700E-06 9.16027463692E-06 9.34530920022E-06 9.53408108693E-06 9.72666577057E-06 9.92314024831E-06 1.01235830717E-05 1.03280743779E-05 1.05366959219E-05 1.07495311091E-05 1.09666650283E-05 1.11881844861E-05 1.14141780413E-05 1.16447360401E-05 1.18799506526E-05 1.21199159091E-05 1.23647277380E-05 1.26144840037E-05 1.28692845460E-05 1.31292312198E-05 1.33944279357E-05 1.36649807012E-05 1.39409976638E-05 1.42225891530E-05 1.45098677252E-05 1.48029482084E-05 1.51019477475E-05 1.54069858518E-05 1.57181844420E-05 1.60356678989E-05 1.63595631136E-05 1.66899995373E-05 1.70271092333E-05 1.73710269295E-05 1.77218900724E-05 1.80798388815E-05 1.84450164053E-05 1.88175685784E-05 1.91976442797E-05 1.95853953915E-05 1.99809768602E-05 2.03845467577E-05 2.07962663449E-05 2.12163001356E-05 2.16448159619E-05 2.20819850414E-05 2.25279820450E-05 2.29829851669E-05 2.34471761949E-05 2.39207405834E-05 2.44038675268E-05 2.48967500351E-05 2.53995850105E-05 2.59125733259E-05 2.64359199044E-05 2.69698338017E-05 2.75145282882E-05 2.80702209349E-05 2.86371336988E-05 2.92154930122E-05 2.98055298721E-05 3.04074799322E-05 3.10215835967E-05 3.16480861155E-05 3.22872376822E-05 3.29392935331E-05 3.36045140486E-05 3.42831648569E-05 3.49755169394E-05 3.56818467382E-05 3.64024362659E-05 3.71375732177E-05 3.78875510855E-05 3.86526692744E-05 3.94332332215E-05 4.02295545170E-05 4.10419510282E-05 4.18707470250E-05 4.27162733088E-05 4.35788673439E-05 4.44588733906E-05 4.53566426424E-05 4.62725333647E-05 4.72069110370E-05 4.81601484974E-05 4.91326260905E-05 5.01247318179E-05 5.11368614918E-05 5.21694188917E-05 5.32228159242E-05 5.42974727860E-05 5.53938181298E-05 5.65122892343E-05 5.76533321767E-05 5.88174020090E-05 6.00049629383E-05 6.12164885096E-05 6.24524617932E-05 6.37133755751E-05 6.49997325522E-05 6.63120455300E-05 6.76508376250E-05 6.90166424717E-05 7.04100044321E-05 7.18314788109E-05 7.32816320744E-05 7.47610420730E-05 7.62702982696E-05 7.78100019712E-05 7.93807665656E-05 8.09832177630E-05 8.26179938418E-05 8.42857458998E-05 8.59871381100E-05 8.77228479816E-05 8.94935666262E-05 9.12999990289E-05 9.31428643253E-05 9.50228960833E-05 9.69408425912E-05 9.88974671506E-05 1.00893548376E-04 1.02929880499E-04 1.05007273680E-04 1.07126554325E-04 1.09288565409E-04 1.11494166805E-04 1.13744235621E-04 1.16039666542E-04 1.18381372178E-04 1.20770283423E-04 1.23207349818E-04 1.25693539916E-04 1.28229841666E-04 1.30817262794E-04 1.33456831197E-04 1.36149595339E-04 1.38896624665E-04 1.41699010011E-04 1.44557864031E-04 1.47474321624E-04 1.50449540382E-04 1.53484701031E-04 1.56581007893E-04 1.59739689349E-04 1.62961998317E-04 1.66249212735E-04 1.69602636053E-04 1.73023597739E-04 1.76513453791E-04 1.80073587257E-04 1.83705408772E-04 1.87410357096E-04 1.91189899671E-04 1.95045533183E-04 1.98978784137E-04 2.02991209443E-04 2.07084397010E-04 2.11259966357E-04 2.15519569231E-04 2.19864890238E-04 2.24297647488E-04 2.28819593246E-04 2.33432514606E-04 2.38138234165E-04 2.42938610719E-04 2.47835539969E-04 2.52830955242E-04 2.57926828218E-04 2.63125169684E-04 2.68428030288E-04 2.73837501317E-04 2.79355715484E-04 2.84984847734E-04 2.90727116060E-04 2.96584782338E-04 3.02560153175E-04 3.08655580774E-04 3.14873463815E-04 3.21216248351E-04 3.27686428720E-04 3.34286548478E-04 3.41019201339E-04 3.47887032148E-04 3.54892737853E-04 3.62039068511E-04 3.69328828300E-04 3.76764876557E-04 3.84350128833E-04 3.92087557960E-04 3.99980195148E-04 4.08031131097E-04 4.16243517122E-04 4.24620566309E-04 4.33165554683E-04 4.41881822404E-04 4.50772774971E-04 4.59841884468E-04 4.69092690805E-04 4.78528803008E-04 4.88153900508E-04 4.97971734466E-04 5.07986129117E-04 5.18200983136E-04 5.28620271029E-04 5.39248044541E-04 5.50088434101E-04 5.61145650276E-04 5.72423985262E-04 5.83927814388E-04 5.95661597657E-04 6.07629881301E-04 6.19837299370E-04 6.32288575342E-04 6.44988523759E-04 6.57942051892E-04 6.71154161431E-04 6.84629950202E-04 6.98374613909E-04 7.12393447907E-04 7.26691848999E-04 7.41275317264E-04 7.56149457910E-04 7.71319983155E-04 7.86792714140E-04 8.02573582869E-04 8.18668634171E-04 8.35084027705E-04 8.51826039978E-04 8.68901066404E-04 8.86315623389E-04 9.04076350441E-04 9.22190012315E-04 9.40663501184E-04 9.59503838845E-04 9.78718178944E-04 9.98313809243E-04 1.01829815391E-03 1.03867877583E-03 1.05946337897E-03 1.08065981076E-03 1.10227606448E-03 1.12432028170E-03 1.14680075479E-03 1.16972592935E-03 1.19310440679E-03 1.21694494684E-03 1.24125647016E-03 1.26604806094E-03 1.29132896953E-03 1.31710861509E-03 1.34339658830E-03 1.37020265408E-03 1.39753675428E-03 1.42540901049E-03 1.45382972683E-03 1.48280939270E-03 1.51235868570E-03 1.54248847439E-03 1.57320982124E-03 1.60453398547E-03 1.63647242599E-03 1.66903680431E-03 1.70223898748E-03 1.73609105107E-03 1.77060528212E-03 1.80579418211E-03 1.84167046998E-03 1.87824708511E-03 1.91553719031E-03 1.95355417486E-03 1.99231165750E-03 2.03182348943E-03 2.07210375732E-03 2.11316678636E-03 2.15502714317E-03 2.19769963884E-03 2.24119933188E-03 2.28554153120E-03 2.33074179899E-03 2.37681595368E-03 2.42378007281E-03 2.47165049587E-03 2.52044382713E-03 2.57017693842E-03 2.62086697188E-03 2.67253134262E-03 2.72518774138E-03 2.77885413713E-03 2.83354877955E-03 2.88929020150E-03 2.94609722141E-03 3.00398894556E-03 3.06298477030E-03 3.12310438419E-03 3.18436776997E-03 3.24679520655E-03 3.31040727073E-03 3.37522483894E-03 3.44126908879E-03 3.50856150042E-03 3.57712385785E-03 3.64697825002E-03 3.71814707176E-03 3.79065302457E-03 3.86451911718E-03 3.93976866591E-03 4.01642529493E-03 4.09451293609E-03 4.17405582877E-03 4.25507851924E-03 4.33760585995E-03 4.42166300847E-03 4.50727542611E-03 4.59446887630E-03 4.68326942264E-03 4.77370342659E-03 4.86579754482E-03 4.95957872624E-03 5.05507420854E-03 5.15231151447E-03 5.25131844756E-03 5.35212308750E-03 5.45475378497E-03 5.55923915611E-03 5.66560807631E-03 5.77388967367E-03 5.88411332172E-03 5.99630863173E-03 6.11050544427E-03 6.22673382027E-03 6.34502403135E-03 6.46540654948E-03 6.58791203596E-03 6.71257132964E-03 6.83941543434E-03 6.96847550558E-03 7.09978283630E-03 7.23336884191E-03 7.36926504429E-03 7.50750305493E-03 7.64811455710E-03 7.79113128699E-03 7.93658501382E-03 8.08450751883E-03 8.23493057326E-03 8.38788591501E-03 8.54340522424E-03 8.70152009760E-03 8.86226202129E-03 9.02566234269E-03 9.19175224065E-03 9.36056269438E-03 9.53212445079E-03 9.70646799041E-03 9.88362349164E-03 1.00636207935E-02 1.02464893565E-02 1.04322582221E-02 1.06209559702E-02 1.08126106745E-02 1.10072498570E-02 1.12049004392E-02 1.14055886923E-02 1.16093401849E-02 1.18161797293E-02 1.20261313241E-02 1.22392180966E-02 1.24554622414E-02 1.26748849575E-02 1.28975063824E-02 1.31233455244E-02 1.33524201925E-02 1.35847469225E-02 1.38203409025E-02 1.40592158941E-02 1.43013841517E-02 1.45468563388E-02 1.47956414420E-02 1.50477466815E-02 1.53031774191E-02 1.55619370635E-02 1.58240269721E-02 1.60894463506E-02 1.63581921486E-02 1.66302589533E-02 1.69056388795E-02 1.71843214564E-02 1.74662935117E-02 1.77515390526E-02 1.80400391436E-02 1.83317717812E-02 1.86267117658E-02 1.89248305698E-02 1.92260962041E-02 1.95304730802E-02 1.98379218700E-02 2.01483993632E-02 2.04618583207E-02 2.07782473267E-02 2.10975106370E-02 2.14195880255E-02 2.17444146280E-02 2.20719207838E-02 2.24020318750E-02 2.27346681646E-02 2.30697446315E-02 2.34071708051E-02 2.37468505980E-02 2.40886821380E-02 2.44325575983E-02 2.47783630283E-02 2.51259781836E-02 2.54752763555E-02 2.58261242020E-02 2.61783815790E-02 2.65319013722E-02 2.68865293318E-02 2.72421039083E-02 2.75984560913E-02 2.79554092511E-02 2.83127789846E-02 2.86703729650E-02 2.90279907961E-02 2.93854238730E-02 2.97424552478E-02 3.00988595041E-02 3.04544026371E-02 3.08088419439E-02 3.11619259226E-02 3.15133941816E-02 3.18629773604E-02 3.22103970623E-02 3.25553658006E-02 3.28975869590E-02 3.32367547669E-02 3.35725542921E-02 3.39046614503E-02 3.42327430334E-02 3.45564567590E-02 3.48754513399E-02 3.51893665769E-02 3.54978334759E-02 3.58004743900E-02 3.60969031881E-02 3.63867254528E-02 3.66695387067E-02 3.69449326707E-02 3.72124895543E-02 3.74717843807E-02 3.77223853467E-02 3.79638542200E-02 3.81957467753E-02 3.84176132694E-02 3.86289989589E-02 3.88294446599E-02 3.90184873516E-02 3.91956608263E-02 3.93604963852E-02 3.95125235823E-02 3.96512710170E-02 3.97762671769E-02 3.98870413314E-02 3.99831244763E-02 4.00640503306E-02 4.01293563867E-02 4.01785850123E-02 4.02112846058E-02 4.02270108046E-02 4.02253277458E-02 4.02058093790E-02 4.01680408297E-02 4.01116198138E-02 4.00361580995E-02 3.99412830174E-02 3.98266390142E-02 3.96918892501E-02 3.95367172353E-02 3.93608285030E-02 3.91639523154E-02 3.89458433992E-02 3.87062837049E-02 3.84450841855E-02 3.81620865904E-02 3.78571652662E-02 3.75302289598E-02 3.71812226167E-02 3.68101291659E-02 3.64169712843E-02 3.60018131321E-02 3.55647620497E-02 3.51059702060E-02 3.46256361894E-02 3.41240065292E-02 3.36013771373E-02 3.30580946577E-02 3.24945577124E-02 3.19112180308E-02 3.13085814492E-02 3.06872087682E-02 3.00477164528E-02 2.93907771632E-02 2.87171201008E-02 2.80275311558E-02 2.73228528422E-02 2.66039840065E-02 2.58718792957E-02 2.51275483702E-02 2.43720548506E-02 2.36065149828E-02 2.28320960110E-02 2.20500142464E-02 2.12615328220E-02 2.04679591218E-02 1.96706418794E-02 1.88709679356E-02 1.80703586522E-02 1.72702659770E-02 1.64721681587E-02 1.56775651118E-02 1.48879734336E-02 1.41049210798E-02 1.33299417036E-02 1.25645686720E-02 1.18103287689E-02 1.10687356052E-02 1.03412827519E-02 9.62943662299E-03 8.93462913100E-03 8.25825014871E-03 7.60163980890E-03 6.96608068081E-03 6.35278986456E-03 5.76291104888E-03 5.19750658131E-03 4.65754960345E-03 4.14391630763E-03 3.65737837453E-03 3.19859565456E-03 2.76810915827E-03 2.36633442408E-03 1.99355533298E-03 1.64991844191E-03 1.33542790800E-03 1.04994107653E-03 7.93164804673E-04 5.64652591784E-04 3.63802585014E-04 1.89856525436E-04 4.18996957356E-05 -8.11380750984E-05 -1.80480301428E-04 -2.57500584460E-04 -3.13718178590E-04 -3.50792360624E-04 -3.70515594387E-04 -3.74805497233E-04 -3.65695630522E-04 -3.45325153138E-04 -3.15927395617E-04 -2.79817432291E-04 -2.39378749923E-04 -1.97049133471E-04 -1.55305912647E-04 -1.16650736519E-04 -8.32403950402E-05 -5.57408152677E-05 -3.42460683960E-05 -1.85867227399E-05 -8.30012270977E-06 -2.59964518973E-06 -3.43042055624E-07 -1.44437150288E-16 2.23142031311E-17 5.85604521372E-18 -1.53125370908E-17 -1.74616203082E-16 1.12401081450E-17 -2.73902094227E-17 1.49231841577E-17 -1.77481713143E-17 2.02555677469E-17 -1.23434501365E-17 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1 2 0 i j (l(j)) 1.52438936704E-02 Q_int 2.94757945071E-06 3.00712257234E-06 3.06786846593E-06 3.12984142586E-06 3.19306623717E-06 3.25756818544E-06 3.32337306692E-06 3.39050719883E-06 3.45899742988E-06 3.52887115099E-06 3.60015630626E-06 3.67288140411E-06 3.74707552871E-06 3.82276835155E-06 3.89999014335E-06 3.97877178614E-06 4.05914478557E-06 4.14114128354E-06 4.22479407104E-06 4.31013660122E-06 4.39720300281E-06 4.48602809369E-06 4.57664739487E-06 4.66909714462E-06 4.76341431302E-06 4.85963661665E-06 4.95780253372E-06 5.05795131943E-06 5.16012302161E-06 5.26435849680E-06 5.37069942648E-06 5.47918833379E-06 5.58986860050E-06 5.70278448430E-06 5.81798113654E-06 5.93550462021E-06 6.05540192838E-06 6.17772100294E-06 6.30251075376E-06 6.42982107822E-06 6.55970288115E-06 6.69220809514E-06 6.82738970129E-06 6.96530175036E-06 7.10599938436E-06 7.24953885857E-06 7.39597756399E-06 7.54537405026E-06 7.69778804905E-06 7.85328049789E-06 8.01191356448E-06 8.17375067157E-06 8.33885652220E-06 8.50729712560E-06 8.67913982348E-06 8.85445331695E-06 9.03330769389E-06 9.21577445700E-06 9.40192655226E-06 9.59183839808E-06 9.78558591500E-06 9.98324655594E-06 1.01848993372E-05 1.03906248698E-05 1.06005053919E-05 1.08146248014E-05 1.10330686895E-05 1.12559243749E-05 1.14832809384E-05 1.17152292586E-05 1.19518620483E-05 1.21932738912E-05 1.24395612796E-05 1.26908226532E-05 1.29471584382E-05 1.32086710869E-05 1.34754651194E-05 1.37476471646E-05 1.40253260029E-05 1.43086126095E-05 1.45976201990E-05 1.48924642699E-05 1.51932626510E-05 1.55001355486E-05 1.58132055937E-05 1.61325978916E-05 1.64584400711E-05 1.67908623359E-05 1.71299975160E-05 1.74759811211E-05 1.78289513939E-05 1.81890493658E-05 1.85564189127E-05 1.89312068123E-05 1.93135628028E-05 1.97036396421E-05 2.01015931689E-05 2.05075823646E-05 2.09217694167E-05 2.13443197831E-05 2.17754022582E-05 2.22151890397E-05 2.26638557975E-05 2.31215817433E-05 2.35885497020E-05 2.40649461843E-05 2.45509614609E-05 2.50467896382E-05 2.55526287353E-05 2.60686807629E-05 2.65951518034E-05 2.71322520928E-05 2.76801961045E-05 2.82392026341E-05 2.88094948865E-05 2.93913005644E-05 2.99848519591E-05 3.05903860422E-05 3.12081445600E-05 3.18383741293E-05 3.24813263353E-05 3.31372578314E-05 3.38064304410E-05 3.44891112616E-05 3.51855727701E-05 3.58960929314E-05 3.66209553085E-05 3.73604491745E-05 3.81148696277E-05 3.88845177082E-05 3.96697005173E-05 4.04707313392E-05 4.12879297645E-05 4.21216218174E-05 4.29721400845E-05 4.38398238462E-05 4.47250192110E-05 4.56280792527E-05 4.65493641493E-05 4.74892413264E-05 4.84480856014E-05 4.94262793322E-05 5.04242125682E-05 5.14422832040E-05 5.24808971371E-05 5.35404684274E-05 5.46214194611E-05 5.57241811171E-05 5.68491929372E-05 5.79969032989E-05 5.91677695927E-05 6.03622584020E-05 6.15808456869E-05 6.28240169719E-05 6.40922675366E-05 6.53861026110E-05 6.67060375742E-05 6.80525981567E-05 6.94263206479E-05 7.08277521058E-05 7.22574505729E-05 7.37159852948E-05 7.52039369437E-05 7.67218978464E-05 7.82704722169E-05 7.98502763926E-05 8.14619390766E-05 8.31061015835E-05 8.47834180912E-05 8.64945558959E-05 8.82401956745E-05 9.00210317496E-05 9.18377723619E-05 9.36911399463E-05 9.55818714141E-05 9.75107184412E-05 9.94784477606E-05 1.01485841462E-04 1.03533697296E-04 1.05622828986E-04 1.07754066544E-04 1.09928256592E-04 1.12146262697E-04 1.14408965698E-04 1.16717264057E-04 1.19072074201E-04 1.21474330881E-04 1.23924987534E-04 1.26425016651E-04 1.28975410155E-04 1.31577179786E-04 1.34231357487E-04 1.36938995811E-04 1.39701168319E-04 1.42518970000E-04 1.45393517690E-04 1.48325950505E-04 1.51317430277E-04 1.54369142003E-04 1.57482294298E-04 1.60658119862E-04 1.63897875951E-04 1.67202844861E-04 1.70574334414E-04 1.74013678468E-04 1.77522237416E-04 1.81101398714E-04 1.84752577408E-04 1.88477216671E-04 1.92276788355E-04 1.96152793552E-04 2.00106763162E-04 2.04140258476E-04 2.08254871767E-04 2.12452226894E-04 2.16733979917E-04 2.21101819721E-04 2.25557468655E-04 2.30102683183E-04 2.34739254541E-04 2.39469009415E-04 2.44293810626E-04 2.49215557826E-04 2.54236188214E-04 2.59357677259E-04 2.64582039436E-04 2.69911328980E-04 2.75347640650E-04 2.80893110509E-04 2.86549916717E-04 2.92320280336E-04 2.98206466156E-04 3.04210783531E-04 3.10335587228E-04 3.16583278298E-04 3.22956304957E-04 3.29457163486E-04 3.36088399140E-04 3.42852607088E-04 3.49752433350E-04 3.56790575769E-04 3.63969784984E-04 3.71292865436E-04 3.78762676375E-04 3.86382132897E-04 3.94154206996E-04 4.02081928626E-04 4.10168386796E-04 4.18416730670E-04 4.26830170694E-04 4.35411979735E-04 4.44165494251E-04 4.53094115466E-04 4.62201310575E-04 4.71490613967E-04 4.80965628465E-04 4.90630026587E-04 5.00487551833E-04 5.10542019987E-04 5.20797320442E-04 5.31257417546E-04 5.41926351973E-04 5.52808242107E-04 5.63907285460E-04 5.75227760102E-04 5.86774026118E-04 5.98550527088E-04 6.10561791587E-04 6.22812434709E-04 6.35307159617E-04 6.48050759110E-04 6.61048117220E-04 6.74304210829E-04 6.87824111309E-04 7.01612986186E-04 7.15676100831E-04 7.30018820174E-04 7.44646610435E-04 7.59565040890E-04 7.74779785655E-04 7.90296625493E-04 8.06121449650E-04 8.22260257711E-04 8.38719161481E-04 8.55504386893E-04 8.72622275936E-04 8.90079288612E-04 9.07882004909E-04 9.26037126808E-04 9.44551480302E-04 9.63432017453E-04 9.82685818456E-04 1.00232009374E-03 1.02234218607E-03 1.04275957273E-03 1.06357986762E-03 1.08481082349E-03 1.10646033414E-03 1.12853643661E-03 1.15104731346E-03 1.17400129505E-03 1.19740686177E-03 1.22127264639E-03 1.24560743636E-03 1.27042017615E-03 1.29571996961E-03 1.32151608235E-03 1.34781794409E-03 1.37463515109E-03 1.40197746854E-03 1.42985483300E-03 1.45827735479E-03 1.48725532050E-03 1.51679919536E-03 1.54691962574E-03 1.57762744158E-03 1.60893365887E-03 1.64084948211E-03 1.67338630675E-03 1.70655572166E-03 1.74036951156E-03 1.77483965950E-03 1.80997834928E-03 1.84579796784E-03 1.88231110771E-03 1.91953056939E-03 1.95746936372E-03 1.99614071421E-03 2.03555805938E-03 2.07573505505E-03 2.11668557660E-03 2.15842372120E-03 2.20096380997E-03 2.24432039014E-03 2.28850823715E-03 2.33354235665E-03 2.37943798653E-03 2.42621059879E-03 2.47387590145E-03 2.52244984027E-03 2.57194860050E-03 2.62238860846E-03 2.67378653312E-03 2.72615928750E-03 2.77952402998E-03 2.83389816558E-03 2.88929934706E-03 2.94574547584E-03 3.00325470296E-03 3.06184542968E-03 3.12153630817E-03 3.18234624180E-03 3.24429438551E-03 3.30740014578E-03 3.37168318058E-03 3.43716339905E-03 3.50386096101E-03 3.57179627619E-03 3.64099000332E-03 3.71146304894E-03 3.78323656594E-03 3.85633195184E-03 3.93077084686E-03 4.00657513160E-03 4.08376692450E-03 4.16236857888E-03 4.24240267980E-03 4.32389204038E-03 4.40685969791E-03 4.49132890950E-03 4.57732314732E-03 4.66486609350E-03 4.75398163444E-03 4.84469385485E-03 4.93702703116E-03 5.03100562450E-03 5.12665427317E-03 5.22399778449E-03 5.32306112620E-03 5.42386941718E-03 5.52644791760E-03 5.63082201839E-03 5.73701723013E-03 5.84505917114E-03 5.95497355495E-03 6.06678617697E-03 6.18052290041E-03 6.29620964137E-03 6.41387235311E-03 6.53353700952E-03 6.65522958754E-03 6.77897604883E-03 6.90480232034E-03 7.03273427395E-03 7.16279770508E-03 7.29501831020E-03 7.42942166325E-03 7.56603319095E-03 7.70487814685E-03 7.84598158428E-03 7.98936832792E-03 8.13506294418E-03 8.28308971015E-03 8.43347258124E-03 8.58623515734E-03 8.74140064759E-03 8.89899183357E-03 9.05903103096E-03 9.22154004965E-03 9.38654015214E-03 9.55405201032E-03 9.72409566046E-03 9.89669045652E-03 1.00718550215E-02 1.02496071972E-02 1.04299639915E-02 1.06129415246E-02 1.07985549724E-02 1.09868185081E-02 1.11777452422E-02 1.13713471597E-02 1.15676350553E-02 1.17666184670E-02 1.19683056063E-02 1.21727032876E-02 1.23798168538E-02 1.25896501007E-02 1.28022051981E-02 1.30174826096E-02 1.32354810088E-02 1.34561971940E-02 1.36796259994E-02 1.39057602054E-02 1.41345904443E-02 1.43661051057E-02 1.46002902373E-02 1.48371294452E-02 1.50766037900E-02 1.53186916814E-02 1.55633687699E-02 1.58106078366E-02 1.60603786800E-02 1.63126480003E-02 1.65673792826E-02 1.68245326761E-02 1.70840648728E-02 1.73459289829E-02 1.76100744086E-02 1.78764467162E-02 1.81449875061E-02 1.84156342813E-02 1.86883203145E-02 1.89629745131E-02 1.92395212841E-02 1.95178803972E-02 1.97979668473E-02 2.00796907163E-02 2.03629570349E-02 2.06476656438E-02 2.09337110554E-02 2.12209823160E-02 2.15093628685E-02 2.17987304162E-02 2.20889567889E-02 2.23799078097E-02 2.26714431648E-02 2.29634162762E-02 2.32556741768E-02 2.35480573904E-02 2.38403998144E-02 2.41325286089E-02 2.44242640898E-02 2.47154196289E-02 2.50058015595E-02 2.52952090907E-02 2.55834342284E-02 2.58702617057E-02 2.61554689227E-02 2.64388258967E-02 2.67200952229E-02 2.69990320485E-02 2.72753840578E-02 2.75488914731E-02 2.78192870692E-02 2.80862962036E-02 2.83496368646E-02 2.86090197364E-02 2.88641482833E-02 2.91147188541E-02 2.93604208079E-02 2.96009366618E-02 2.98359422625E-02 3.00651069823E-02 3.02880939411E-02 3.05045602560E-02 3.07141573179E-02 3.09165310990E-02 3.11113224904E-02 3.12981676710E-02 3.14766985109E-02 3.16465430073E-02 3.18073257569E-02 3.19586684643E-02 3.21001904876E-02 3.22315094229E-02 3.23522417273E-02 3.24620033831E-02 3.25604106017E-02 3.26470805699E-02 3.27216322379E-02 3.27836871500E-02 3.28328703177E-02 3.28688111364E-02 3.28911443445E-02 3.28995110257E-02 3.28935596529E-02 3.28729471753E-02 3.28373401452E-02 3.27864158857E-02 3.27198636967E-02 3.26373860981E-02 3.25387001090E-02 3.24235385595E-02 3.22916514334E-02 3.21428072395E-02 3.19767944073E-02 3.17934227046E-02 3.15925246725E-02 3.13739570739E-02 3.11376023509E-02 3.08833700857E-02 3.06111984604E-02 3.03210557078E-02 3.00129415503E-02 2.96868886162E-02 2.93429638290E-02 2.89812697613E-02 2.86019459447E-02 2.82051701275E-02 2.77911594718E-02 2.73601716796E-02 2.69125060398E-02 2.64485043842E-02 2.59685519435E-02 2.54730780922E-02 2.49625569712E-02 2.44375079775E-02 2.38984961094E-02 2.33461321557E-02 2.27810727176E-02 2.22040200523E-02 2.16157217266E-02 2.10169700685E-02 2.04086014084E-02 1.97914950968E-02 1.91665722902E-02 1.85347944953E-02 1.78971618624E-02 1.72547112212E-02 1.66085138507E-02 1.59596729787E-02 1.53093210053E-02 1.46586164479E-02 1.40087406048E-02 1.33608939396E-02 1.27162921847E-02 1.20761621711E-02 1.14417373880E-02 1.08142532804E-02 1.01949422961E-02 9.58502869467E-03 8.98572313248E-03 8.39821704440E-03 7.82367684156E-03 7.26323794990E-03 6.71799871660E-03 6.18901421442E-03 5.67728997721E-03 5.18377570295E-03 4.70935896371E-03 4.25485896479E-03 3.82102039841E-03 3.40850743983E-03 3.01789793649E-03 2.64967784307E-03 2.30423595726E-03 1.98185901289E-03 1.68272718825E-03 1.40691008829E-03 1.15436325968E-03 9.24925297463E-04 7.18315600879E-04 5.34132834581E-04 3.71854148650E-04 2.30835207643E-04 1.10311074569E-04 9.39799037958E-06 -7.29039167300E-05 -1.37706965400E-04 -1.86231280290E-04 -2.19799167855E-04 -2.39828511124E-04 -2.47825197970E-04 -2.45374610635E-04 -2.34132218600E-04 -2.15813332298E-04 -1.92182091467E-04 -1.65039779053E-04 -1.36212569294E-04 -1.07538836754E-04 -8.08561713633E-05 -5.77370299767E-05 -3.86790107203E-05 -2.37678891405E-05 -1.28992425529E-05 -5.75886907078E-06 -1.80290256718E-06 -2.37750464829E-07 -1.23342023948E-17 7.58010841858E-18 9.13112058106E-18 -1.27779244048E-17 -7.54916640432E-17 -2.74341614786E-17 -1.84999381883E-17 1.15187438673E-17 1.20078154831E-17 -7.32486172123E-19 -1.73224799183E-17 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2 2 0 i j (l(j)) 1.24529070693E-02 Q_int 2.42648687827E-06 2.47550356057E-06 2.52551038008E-06 2.57652733620E-06 2.62857483229E-06 2.68167368372E-06 2.73584512629E-06 2.79111082462E-06 2.84749288089E-06 2.90501384363E-06 2.96369671674E-06 3.02356496869E-06 3.08464254189E-06 3.14695386226E-06 3.21052384900E-06 3.27537792455E-06 3.34154202471E-06 3.40904260908E-06 3.47790667154E-06 3.54816175113E-06 3.61983594297E-06 3.69295790954E-06 3.76755689213E-06 3.84366272249E-06 3.92130583477E-06 4.00051727770E-06 4.08132872694E-06 4.16377249779E-06 4.24788155807E-06 4.33368954130E-06 4.42123076014E-06 4.51054022008E-06 4.60165363344E-06 4.69460743362E-06 4.78943878966E-06 4.88618562112E-06 4.98488661315E-06 5.08558123202E-06 5.18830974081E-06 5.29311321556E-06 5.40003356162E-06 5.50911353042E-06 5.62039673651E-06 5.73392767501E-06 5.84975173936E-06 5.96791523943E-06 6.08846542005E-06 6.21145047982E-06 6.33691959042E-06 6.46492291618E-06 6.59551163412E-06 6.72873795442E-06 6.86465514121E-06 7.00331753386E-06 7.14478056867E-06 7.28910080098E-06 7.43633592774E-06 7.58654481058E-06 7.73978749923E-06 7.89612525555E-06 8.05562057794E-06 8.21833722628E-06 8.38434024738E-06 8.55369600092E-06 8.72647218595E-06 8.90273786787E-06 9.08256350599E-06 9.26602098164E-06 9.45318362685E-06 9.64412625357E-06 9.83892518353E-06 1.00376582787E-05 1.02404049722E-05 1.04472463003E-05 1.06582649343E-05 1.08735452138E-05 1.10931731802E-05 1.13172366112E-05 1.15458250553E-05 1.17790298680E-05 1.20169442482E-05 1.22596632747E-05 1.25072839451E-05 1.27599052136E-05 1.30176280306E-05 1.32805553834E-05 1.35487923367E-05 1.38224460747E-05 1.41016259435E-05 1.43864434952E-05 1.46770125319E-05 1.49734491509E-05 1.52758717914E-05 1.55844012813E-05 1.58991608855E-05 1.62202763546E-05 1.65478759755E-05 1.68820906220E-05 1.72230538072E-05 1.75709017363E-05 1.79257733610E-05 1.82878104348E-05 1.86571575693E-05 1.90339622916E-05 1.94183751034E-05 1.98105495403E-05 2.02106422330E-05 2.06188129699E-05 2.10352247603E-05 2.14600438991E-05 2.18934400330E-05 2.23355862282E-05 2.27866590386E-05 2.32468385764E-05 2.37163085831E-05 2.41952565033E-05 2.46838735582E-05 2.51823548220E-05 2.56908992994E-05 2.62097100044E-05 2.67389940407E-05 2.72789626841E-05 2.78298314664E-05 2.83918202606E-05 2.89651533682E-05 2.95500596080E-05 3.01467724070E-05 3.07555298931E-05 3.13765749886E-05 3.20101555075E-05 3.26565242528E-05 3.33159391173E-05 3.39886631851E-05 3.46749648360E-05 3.53751178517E-05 3.60894015243E-05 3.68181007664E-05 3.75615062240E-05 3.83199143914E-05 3.90936277284E-05 3.98829547798E-05 4.06882102972E-05 4.15097153636E-05 4.23477975199E-05 4.32027908944E-05 4.40750363345E-05 4.49648815415E-05 4.58726812073E-05 4.67987971546E-05 4.77435984795E-05 4.87074616969E-05 4.96907708889E-05 5.06939178560E-05 5.17173022714E-05 5.27613318384E-05 5.38264224507E-05 5.49129983560E-05 5.60214923232E-05 5.71523458118E-05 5.83060091460E-05 5.94829416913E-05 6.06836120350E-05 6.19084981699E-05 6.31580876823E-05 6.44328779426E-05 6.57333763008E-05 6.70601002851E-05 6.84135778048E-05 6.97943473567E-05 7.12029582361E-05 7.26399707517E-05 7.41059564445E-05 7.56014983112E-05 7.71271910323E-05 7.86836412040E-05 8.02714675747E-05 8.18913012870E-05 8.35437861232E-05 8.52295787564E-05 8.69493490062E-05 8.87037800996E-05 9.04935689365E-05 9.23194263607E-05 9.41820774363E-05 9.60822617292E-05 9.80207335942E-05 9.99982624672E-05 1.02015633164E-04 1.04073646184E-04 1.06173118020E-04 1.08314881474E-04 1.10499785980E-04 1.12728697931E-04 1.15002501014E-04 1.17322096551E-04 1.19688403846E-04 1.22102360539E-04 1.24564922967E-04 1.27077066534E-04 1.29639786080E-04 1.32254096271E-04 1.34921031979E-04 1.37641648688E-04 1.40417022891E-04 1.43248252505E-04 1.46136457290E-04 1.49082779277E-04 1.52088383202E-04 1.55154456954E-04 1.58282212021E-04 1.61472883957E-04 1.64727732847E-04 1.68048043787E-04 1.71435127371E-04 1.74890320188E-04 1.78414985326E-04 1.82010512888E-04 1.85678320516E-04 1.89419853926E-04 1.93236587452E-04 1.97130024598E-04 2.01101698607E-04 2.05153173032E-04 2.09286042323E-04 2.13501932422E-04 2.17802501371E-04 2.22189439932E-04 2.26664472212E-04 2.31229356307E-04 2.35885884954E-04 2.40635886194E-04 2.45481224052E-04 2.50423799218E-04 2.55465549757E-04 2.60608451814E-04 2.65854520345E-04 2.71205809855E-04 2.76664415148E-04 2.82232472096E-04 2.87912158412E-04 2.93705694451E-04 2.99615344006E-04 3.05643415138E-04 3.11792261004E-04 3.18064280709E-04 3.24461920170E-04 3.30987672993E-04 3.37644081369E-04 3.44433736980E-04 3.51359281925E-04 3.58423409661E-04 3.65628865956E-04 3.72978449862E-04 3.80475014706E-04 3.88121469088E-04 3.95920777908E-04 4.03875963400E-04 4.11990106190E-04 4.20266346364E-04 4.28707884559E-04 4.37317983070E-04 4.46099966974E-04 4.55057225271E-04 4.64193212046E-04 4.73511447646E-04 4.83015519876E-04 4.92709085216E-04 5.02595870052E-04 5.12679671932E-04 5.22964360833E-04 5.33453880454E-04 5.44152249527E-04 5.55063563139E-04 5.66191994088E-04 5.77541794246E-04 5.89117295947E-04 6.00922913391E-04 6.12963144075E-04 6.25242570236E-04 6.37765860315E-04 6.50537770447E-04 6.63563145961E-04 6.76846922907E-04 6.90394129602E-04 7.04209888194E-04 7.18299416243E-04 7.32668028327E-04 7.47321137665E-04 7.62264257760E-04 7.77503004058E-04 7.93043095631E-04 8.08890356876E-04 8.25050719232E-04 8.41530222920E-04 8.58335018694E-04 8.75471369614E-04 8.92945652841E-04 9.10764361438E-04 9.28934106198E-04 9.47461617486E-04 9.66353747091E-04 9.85617470101E-04 1.00525988679E-03 1.02528822452E-03 1.04570983964E-03 1.06653221946E-03 1.08776298412E-03 1.10940988861E-03 1.13148082468E-03 1.15398382284E-03 1.17692705434E-03 1.20031883314E-03 1.22416761792E-03 1.24848201408E-03 1.27327077574E-03 1.29854280773E-03 1.32430716763E-03 1.35057306776E-03 1.37734987720E-03 1.40464712376E-03 1.43247449604E-03 1.46084184536E-03 1.48975918777E-03 1.51923670606E-03 1.54928475166E-03 1.57991384660E-03 1.61113468548E-03 1.64295813735E-03 1.67539524758E-03 1.70845723975E-03 1.74215551748E-03 1.77650166623E-03 1.81150745505E-03 1.84718483835E-03 1.88354595756E-03 1.92060314279E-03 1.95836891443E-03 1.99685598469E-03 2.03607725908E-03 2.07604583787E-03 2.11677501743E-03 2.15827829153E-03 2.20056935257E-03 2.24366209269E-03 2.28757060487E-03 2.33230918386E-03 2.37789232703E-03 2.42433473518E-03 2.47165131319E-03 2.51985717051E-03 2.56896762161E-03 2.61899818627E-03 2.66996458971E-03 2.72188276262E-03 2.77476884096E-03 2.82863916570E-03 2.88351028230E-03 2.93939894006E-03 2.99632209129E-03 3.05429689020E-03 3.11334069170E-03 3.17347104989E-03 3.23470571636E-03 3.29706263820E-03 3.36055995587E-03 3.42521600064E-03 3.49104929192E-03 3.55807853413E-03 3.62632261344E-03 3.69580059404E-03 3.76653171414E-03 3.83853538167E-03 3.91183116951E-03 3.98643881040E-03 4.06237819148E-03 4.13966934836E-03 4.21833245878E-03 4.29838783581E-03 4.37985592062E-03 4.46275727470E-03 4.54711257164E-03 4.63294258831E-03 4.72026819554E-03 4.80911034823E-03 4.89949007482E-03 4.99142846620E-03 5.08494666392E-03 5.18006584780E-03 5.27680722278E-03 5.37519200514E-03 5.47524140785E-03 5.57697662532E-03 5.68041881718E-03 5.78558909138E-03 5.89250848633E-03 6.00119795223E-03 6.11167833143E-03 6.22397033791E-03 6.33809453571E-03 6.45407131645E-03 6.57192087566E-03 6.69166318825E-03 6.81331798264E-03 6.93690471397E-03 7.06244253595E-03 7.18995027163E-03 7.31944638289E-03 7.45094893858E-03 7.58447558150E-03 7.72004349383E-03 7.85766936138E-03 7.99736933622E-03 8.13915899802E-03 8.28305331377E-03 8.42906659602E-03 8.57721245956E-03 8.72750377647E-03 8.87995262953E-03 9.03457026397E-03 9.19136703752E-03 9.35035236865E-03 9.51153468314E-03 9.67492135874E-03 9.84051866808E-03 1.00083317196E-02 1.01783643968E-02 1.03506192951E-02 1.05250976575E-02 1.07017993075E-02 1.08807225806E-02 1.10618642535E-02 1.12452194712E-02 1.14307816725E-02 1.16185425130E-02 1.18084917862E-02 1.20006173430E-02 1.21949050080E-02 1.23913384953E-02 1.25898993212E-02 1.27905667150E-02 1.29933175284E-02 1.31981261425E-02 1.34049643728E-02 1.36138013729E-02 1.38246035357E-02 1.40373343933E-02 1.42519545151E-02 1.44684214044E-02 1.46866893932E-02 1.49067095360E-02 1.51284295018E-02 1.53517934655E-02 1.55767419977E-02 1.58032119535E-02 1.60311363617E-02 1.62604443118E-02 1.64910608415E-02 1.67229068241E-02 1.69558988557E-02 1.71899491421E-02 1.74249653875E-02 1.76608506824E-02 1.78975033939E-02 1.81348170568E-02 1.83726802658E-02 1.86109765713E-02 1.88495843755E-02 1.90883768335E-02 1.93272217557E-02 1.95659815150E-02 1.98045129579E-02 2.00426673199E-02 2.02802901462E-02 2.05172212177E-02 2.07532944842E-02 2.09883380029E-02 2.12221738856E-02 2.14546182531E-02 2.16854811988E-02 2.19145667615E-02 2.21416729082E-02 2.23665915278E-02 2.25891084371E-02 2.28090033979E-02 2.30260501487E-02 2.32400164496E-02 2.34506641426E-02 2.36577492276E-02 2.38610219554E-02 2.40602269378E-02 2.42551032768E-02 2.44453847139E-02 2.46307997982E-02 2.48110720784E-02 2.49859203150E-02 2.51550587179E-02 2.53181972067E-02 2.54750416981E-02 2.56252944184E-02 2.57686542439E-02 2.59048170695E-02 2.60334762061E-02 2.61543228084E-02 2.62670463335E-02 2.63713350301E-02 2.64668764617E-02 2.65533580609E-02 2.66304677182E-02 2.66978944048E-02 2.67553288292E-02 2.68024641288E-02 2.68389965961E-02 2.68646264402E-02 2.68790585827E-02 2.68820034880E-02 2.68731780285E-02 2.68523063829E-02 2.68191209671E-02 2.67733633979E-02 2.67147854868E-02 2.66431502632E-02 2.65582330261E-02 2.64598224208E-02 2.63477215403E-02 2.62217490471E-02 2.60817403153E-02 2.59275485865E-02 2.57590461397E-02 2.55761254693E-02 2.53787004681E-02 2.51667076110E-02 2.49401071347E-02 2.46988842080E-02 2.44430500882E-02 2.41726432572E-02 2.38877305315E-02 2.35884081399E-02 2.32748027616E-02 2.29470725184E-02 2.26054079127E-02 2.22500327044E-02 2.18812047181E-02 2.14992165723E-02 2.11043963229E-02 2.06971080111E-02 2.02777521071E-02 1.98467658413E-02 1.94046234129E-02 1.89518360668E-02 1.84889520299E-02 1.80165562980E-02 1.75352702630E-02 1.70457511728E-02 1.65486914153E-02 1.60448176176E-02 1.55348895532E-02 1.50196988497E-02 1.45000674916E-02 1.39768461104E-02 1.34509120591E-02 1.29231672662E-02 1.23945358653E-02 1.18659616018E-02 1.13384050122E-02 1.08128403802E-02 1.02902524714E-02 9.77163304944E-03 9.25797718256E-03 8.75027934549E-03 8.24952932901E-03 7.75670796819E-03 7.27278270397E-03 6.79870299477E-03 6.33539559718E-03 5.88375973713E-03 5.44466219557E-03 5.01893233510E-03 4.60735709644E-03 4.21067599625E-03 3.82957616013E-03 3.46468742691E-03 3.11657756285E-03 2.78574762600E-03 2.47262752339E-03 2.17757180498E-03 1.90085573984E-03 1.64267172119E-03 1.40312604745E-03 1.18223612694E-03 9.79928153428E-04 7.96035299340E-04 6.30296471751E-04 4.82355674705E-04 3.51762018535E-04 2.37970413605E-04 1.40342981696E-04 5.81512132971E-05 -9.42110681767E-06 -6.32741900737E-05 -1.04387742668E-04 -1.33815672833E-04 -1.52680016904E-04 -1.62164104670E-04 -1.63504995762E-04 -1.57985230812E-04 -1.46923953851E-04 -1.31667475720E-04 -1.13579361984E-04 -9.40301428537E-05 -7.43867566559E-05 -5.60018523046E-05 -4.00246253780E-05 -2.68288519860E-05 -1.64912172027E-05 -8.95060541681E-06 -3.99530370939E-06 -1.25029645581E-06 -1.64774888026E-07 4.18394786855E-17 1.60349756296E-18 -4.44867007563E-18 -5.51102207559E-18 -9.59630044471E-18 -1.22983136583E-17 7.59154944654E-18 1.49597837854E-18 6.21686986749E-18 -7.26783396563E-18 -8.08663349754E-18 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1S 0 1.00 Wavefunction 3.68746577667E-03 3.72452505020E-03 3.76195676424E-03 3.79976466153E-03 3.83795252242E-03 3.87652416525E-03 3.91548344670E-03 3.95483426222E-03 3.99458054639E-03 4.03472627331E-03 4.07527545703E-03 4.11623215192E-03 4.15760045308E-03 4.19938449674E-03 4.24158846072E-03 4.28421656478E-03 4.32727307109E-03 4.37076228463E-03 4.41468855365E-03 4.45905627006E-03 4.50386986991E-03 4.54913383381E-03 4.59485268737E-03 4.64103100168E-03 4.68767339375E-03 4.73478452696E-03 4.78236911156E-03 4.83043190510E-03 4.87897771292E-03 4.92801138864E-03 4.97753783463E-03 5.02756200253E-03 5.07808889368E-03 5.12912355968E-03 5.18067110289E-03 5.23273667690E-03 5.28532548707E-03 5.33844279106E-03 5.39209389931E-03 5.44628417564E-03 5.50101903772E-03 5.55630395765E-03 5.61214446248E-03 5.66854613478E-03 5.72551461320E-03 5.78305559301E-03 5.84117482669E-03 5.89987812448E-03 5.95917135499E-03 6.01906044576E-03 6.07955138388E-03 6.14065021655E-03 6.20236305169E-03 6.26469605859E-03 6.32765546847E-03 6.39124757515E-03 6.45547873562E-03 6.52035537074E-03 6.58588396582E-03 6.65207107132E-03 6.71892330347E-03 6.78644734491E-03 6.85464994541E-03 6.92353792251E-03 6.99311816219E-03 7.06339761959E-03 7.13438331966E-03 7.20608235790E-03 7.27850190105E-03 7.35164918777E-03 7.42553152945E-03 7.50015631082E-03 7.57553099080E-03 7.65166310315E-03 7.72856025728E-03 7.80623013900E-03 7.88468051123E-03 7.96391921485E-03 8.04395416944E-03 8.12479337406E-03 8.20644490807E-03 8.28891693192E-03 8.37221768796E-03 8.45635550126E-03 8.54133878047E-03 8.62717601858E-03 8.71387579387E-03 8.80144677065E-03 8.88989770022E-03 8.97923742167E-03 9.06947486280E-03 9.16061904098E-03 9.25267906408E-03 9.34566413132E-03 9.43958353424E-03 9.53444665761E-03 9.63026298032E-03 9.72704207637E-03 9.82479361581E-03 9.92352736569E-03 1.00232531910E-02 1.01239810558E-02 1.02257210238E-02 1.03284832601E-02 1.04322780313E-02 1.05371157073E-02 1.06430067617E-02 1.07499617734E-02 1.08579914272E-02 1.09671065152E-02 1.10773179375E-02 1.11886367036E-02 1.13010739335E-02 1.14146408584E-02 1.15293488223E-02 1.16452092828E-02 1.17622338125E-02 1.18804340999E-02 1.19998219506E-02 1.21204092886E-02 1.22422081573E-02 1.23652307209E-02 1.24894892653E-02 1.26149961999E-02 1.27417640579E-02 1.28698054984E-02 1.29991333073E-02 1.31297603985E-02 1.32616998153E-02 1.33949647316E-02 1.35295684531E-02 1.36655244191E-02 1.38028462032E-02 1.39415475149E-02 1.40816422012E-02 1.42231442474E-02 1.43660677791E-02 1.45104270632E-02 1.46562365092E-02 1.48035106711E-02 1.49522642484E-02 1.51025120878E-02 1.52542691843E-02 1.54075506831E-02 1.55623718811E-02 1.57187482277E-02 1.58766953274E-02 1.60362289403E-02 1.61973649843E-02 1.63601195365E-02 1.65245088347E-02 1.66905492789E-02 1.68582574333E-02 1.70276500272E-02 1.71987439577E-02 1.73715562901E-02 1.75461042607E-02 1.77224052778E-02 1.79004769234E-02 1.80803369555E-02 1.82620033090E-02 1.84454940983E-02 1.86308276183E-02 1.88180223467E-02 1.90070969455E-02 1.91980702632E-02 1.93909613360E-02 1.95857893903E-02 1.97825738442E-02 1.99813343095E-02 2.01820905933E-02 2.03848627006E-02 2.05896708356E-02 2.07965354038E-02 2.10054770143E-02 2.12165164813E-02 2.14296748265E-02 2.16449732809E-02 2.18624332870E-02 2.20820765006E-02 2.23039247934E-02 2.25280002545E-02 2.27543251929E-02 2.29829221395E-02 2.32138138494E-02 2.34470233040E-02 2.36825737130E-02 2.39204885170E-02 2.41607913895E-02 2.44035062391E-02 2.46486572120E-02 2.48962686943E-02 2.51463653139E-02 2.53989719435E-02 2.56541137025E-02 2.59118159593E-02 2.61721043343E-02 2.64350047016E-02 2.67005431919E-02 2.69687461951E-02 2.72396403621E-02 2.75132526080E-02 2.77896101146E-02 2.80687403324E-02 2.83506709837E-02 2.86354300649E-02 2.89230458496E-02 2.92135468906E-02 2.95069620228E-02 2.98033203662E-02 3.01026513282E-02 3.04049846067E-02 3.07103501925E-02 3.10187783722E-02 3.13302997312E-02 3.16449451563E-02 3.19627458386E-02 3.22837332765E-02 3.26079392784E-02 3.29353959657E-02 3.32661357759E-02 3.36001914653E-02 3.39375961122E-02 3.42783831197E-02 3.46225862190E-02 3.49702394722E-02 3.53213772757E-02 3.56760343630E-02 3.60342458079E-02 3.63960470278E-02 3.67614737867E-02 3.71305621987E-02 3.75033487307E-02 3.78798702062E-02 3.82601638082E-02 3.86442670827E-02 3.90322179421E-02 3.94240546681E-02 3.98198159156E-02 4.02195407158E-02 4.06232684795E-02 4.10310390011E-02 4.14428924612E-02 4.18588694309E-02 4.22790108748E-02 4.27033581548E-02 4.31319530333E-02 4.35648376774E-02 4.40020546616E-02 4.44436469724E-02 4.48896580112E-02 4.53401315983E-02 4.57951119764E-02 4.62546438146E-02 4.67187722117E-02 4.71875427003E-02 4.76610012505E-02 4.81391942735E-02 4.86221686255E-02 4.91099716118E-02 4.96026509900E-02 5.01002549745E-02 5.06028322401E-02 5.11104319258E-02 5.16231036391E-02 5.21408974593E-02 5.26638639421E-02 5.31920541230E-02 5.37255195217E-02 5.42643121461E-02 5.48084844956E-02 5.53580895662E-02 5.59131808537E-02 5.64738123580E-02 5.70400385871E-02 5.76119145615E-02 5.81894958177E-02 5.87728384126E-02 5.93619989277E-02 5.99570344728E-02 6.05580026907E-02 6.11649617604E-02 6.17779704023E-02 6.23970878814E-02 6.30223740117E-02 6.36538891606E-02 6.42916942526E-02 6.49358507737E-02 6.55864207751E-02 6.62434668779E-02 6.69070522766E-02 6.75772407435E-02 6.82540966327E-02 6.89376848841E-02 6.96280710276E-02 7.03253211870E-02 7.10295020840E-02 7.17406810421E-02 7.24589259910E-02 7.31843054700E-02 7.39168886324E-02 7.46567452490E-02 7.54039457122E-02 7.61585610399E-02 7.69206628790E-02 7.76903235097E-02 7.84676158485E-02 7.92526134526E-02 8.00453905231E-02 8.08460219087E-02 8.16545831094E-02 8.24711502798E-02 8.32958002326E-02 8.41286104420E-02 8.49696590471E-02 8.58190248550E-02 8.66767873439E-02 8.75430266666E-02 8.84178236531E-02 8.93012598136E-02 9.01934173418E-02 9.10943791172E-02 9.20042287077E-02 9.29230503727E-02 9.38509290651E-02 9.47879504340E-02 9.57342008265E-02 9.66897672905E-02 9.76547375759E-02 9.86292001372E-02 9.96132441349E-02 1.00606959437E-01 1.01610436621E-01 1.02623766974E-01 1.03647042495E-01 1.04680355896E-01 1.05723800603E-01 1.06777470753E-01 1.07841461200E-01 1.08915867512E-01 1.10000785971E-01 1.11096313575E-01 1.12202548034E-01 1.13319587773E-01 1.14447531928E-01 1.15586480348E-01 1.16736533593E-01 1.17897792928E-01 1.19070360327E-01 1.20254338468E-01 1.21449830732E-01 1.22656941197E-01 1.23875774639E-01 1.25106436524E-01 1.26349033010E-01 1.27603670937E-01 1.28870457827E-01 1.30149501878E-01 1.31440911954E-01 1.32744797588E-01 1.34061268970E-01 1.35390436941E-01 1.36732412986E-01 1.38087309231E-01 1.39455238429E-01 1.40836313953E-01 1.42230649792E-01 1.43638360534E-01 1.45059561363E-01 1.46494368044E-01 1.47942896913E-01 1.49405264866E-01 1.50881589346E-01 1.52371988330E-01 1.53876580317E-01 1.55395484310E-01 1.56928819805E-01 1.58476706774E-01 1.60039265646E-01 1.61616617294E-01 1.63208883012E-01 1.64816184503E-01 1.66438643852E-01 1.68076383509E-01 1.69729526267E-01 1.71398195242E-01 1.73082513845E-01 1.74782605761E-01 1.76498594922E-01 1.78230605483E-01 1.79978761791E-01 1.81743188359E-01 1.83524009836E-01 1.85321350976E-01 1.87135336606E-01 1.88966091592E-01 1.90813740804E-01 1.92678409083E-01 1.94560221202E-01 1.96459301825E-01 1.98375775472E-01 2.00309766474E-01 2.02261398930E-01 2.04230796666E-01 2.06218083185E-01 2.08223381620E-01 2.10246814687E-01 2.12288504632E-01 2.14348573179E-01 2.16427141474E-01 2.18524330030E-01 2.20640258669E-01 2.22775046462E-01 2.24928811662E-01 2.27101671646E-01 2.29293742847E-01 2.31505140682E-01 2.33735979485E-01 2.35986372432E-01 2.38256431467E-01 2.40546267223E-01 2.42855988943E-01 2.45185704397E-01 2.47535519796E-01 2.49905539706E-01 2.52295866957E-01 2.54706602548E-01 2.57137845557E-01 2.59589693033E-01 2.62062239904E-01 2.64555578865E-01 2.67069800278E-01 2.69604992053E-01 2.72161239542E-01 2.74738625415E-01 2.77337229547E-01 2.79957128888E-01 2.82598397343E-01 2.85261105633E-01 2.87945321171E-01 2.90651107916E-01 2.93378526237E-01 2.96127632766E-01 2.98898480252E-01 3.01691117407E-01 3.04505588747E-01 3.07341934439E-01 3.10200190131E-01 3.13080386784E-01 3.15982550504E-01 3.18906702361E-01 3.21852858213E-01 3.24821028515E-01 3.27811218138E-01 3.30823426167E-01 3.33857645709E-01 3.36913863690E-01 3.39992060645E-01 3.43092210511E-01 3.46214280408E-01 3.49358230422E-01 3.52524013376E-01 3.55711574606E-01 3.58920851721E-01 3.62151774371E-01 3.65404263998E-01 3.68678233592E-01 3.71973587438E-01 3.75290220858E-01 3.78628019954E-01 3.81986861336E-01 3.85366611856E-01 3.88767128332E-01 3.92188257273E-01 3.95629834590E-01 3.99091685312E-01 4.02573623295E-01 4.06075450928E-01 4.09596958831E-01 4.13137925553E-01 4.16698117269E-01 4.20277287467E-01 4.23875176636E-01 4.27491511951E-01 4.31126006954E-01 4.34778361232E-01 4.38448260094E-01 4.42135374248E-01 4.45839359466E-01 4.49559856263E-01 4.53296489564E-01 4.57048868370E-01 4.60816585431E-01 4.64599216910E-01 4.68396322056E-01 4.72207442869E-01 4.76032103774E-01 4.79869811290E-01 4.83720053708E-01 4.87582300766E-01 4.91456003330E-01 4.95340593078E-01 4.99235482191E-01 5.03140063043E-01 5.07053707910E-01 5.10975768666E-01 5.14905576507E-01 5.18842441669E-01 5.22785653162E-01 5.26734478512E-01 5.30688163515E-01 5.34645931998E-01 5.38606985605E-01 5.42570503584E-01 5.46535642595E-01 5.50501536534E-01 5.54467296377E-01 5.58432010037E-01 5.62394742244E-01 5.66354534449E-01 5.70310404745E-01 5.74261347817E-01 5.78206334914E-01 5.82144313852E-01 5.86074209038E-01 5.89994921535E-01 5.93905329147E-01 5.97804286549E-01 6.01690625439E-01 6.05563154739E-01 6.09420660827E-01 6.13261907810E-01 6.17085637844E-01 6.20890571489E-01 6.24675408119E-01 6.28438826372E-01 6.32179484656E-01 6.35896021699E-01 6.39587057160E-01 6.43251192287E-01 6.46887010638E-01 6.50493078860E-01 6.54067947523E-01 6.57610152023E-01 6.61118213544E-01 6.64590640089E-01 6.68025927576E-01 6.71422561003E-01 6.74779015680E-01 6.78093758539E-01 6.81365249512E-01 6.84591942976E-01 6.87772289287E-01 6.90904736369E-01 6.93987731400E-01 6.97019722549E-01 6.99999160807E-01 7.02924501884E-01 7.05794208177E-01 7.08606750815E-01 7.11360611772E-01 7.14054286049E-01 7.16686283924E-01 7.19255133260E-01 7.21759381878E-01 7.24197599983E-01 7.26568382638E-01 7.28870352288E-01 7.31102161320E-01 7.33262494653E-01 7.35350072355E-01 7.37363652275E-01 7.39302032676E-01 7.41164054869E-01 7.42948605822E-01 7.44654620745E-01 7.46281085626E-01 7.47827039708E-01 7.49291577889E-01 7.50673853021E-01 7.51973078102E-01 7.53188528324E-01 7.54319542958E-01 7.55365527063E-01 7.56325952969E-01 7.57200361536E-01 7.57988363124E-01 7.58689638273E-01 7.59303938039E-01 7.59831083957E-01 7.60270967594E-01 7.60623549648E-01 7.60888858553E-01 7.61066988551E-01 7.61158097177E-01 7.61162402120E-01 7.61080177407E-01 7.60911748860E-01 7.60657488789E-01 7.60317809856E-01 7.59893158081E-01 7.59384004929E-01 7.58790838450E-01 7.58114153419E-01 7.57354440459E-01 7.56512174112E-01 7.55587799844E-01 7.54581719983E-01 7.53494278598E-01 7.52325745236E-01 7.51076296182E-01 7.49745990040E-01 7.48334742153E-01 7.46842305677E-01 7.45268253998E-01 7.43611958185E-01 7.41872561654E-01 7.40048953442E-01 7.38139740318E-01 7.36143522433E-01 7.34059908382E-01 7.31888814945E-01 7.29630194197E-01 7.27284034003E-01 7.24850358594E-01 7.22329229126E-01 7.19720744219E-01 7.17025040467E-01 7.14242292927E-01 7.11372715585E-01 7.08416561788E-01 7.05374124652E-01 7.02245737434E-01 6.99031773885E-01 6.95732648555E-01 6.92348817078E-01 6.88880776415E-01 6.85329065063E-01 6.81694263229E-01 6.77976992967E-01 6.74177918272E-01 6.70297745142E-01 6.66337221598E-01 6.62297137658E-01 6.58178325280E-01 6.53981658254E-01 6.49708052064E-01 6.45358463696E-01 6.40933891411E-01 6.36435374476E-01 6.31863992854E-01 6.27220866843E-01 6.22507156690E-01 6.17724062148E-01 6.12872822000E-01 6.07954713602E-01 6.02971052868E-01 5.97922927677E-01 5.92811989744E-01 5.87639663766E-01 5.82407410418E-01 5.77116725038E-01 5.71769136787E-01 5.66366207836E-01 5.60909532569E-01 5.55400737179E-01 5.49841478103E-01 5.44233440094E-01 5.38578336401E-01 5.32877908348E-01 5.27133923780E-01 5.21348175963E-01 5.15522482523E-01 5.09658684343E-01 5.03758644456E-01 4.97824246906E-01 4.91857395588E-01 4.85860013073E-01 4.79834039409E-01 4.73781430908E-01 4.67704158909E-01 4.61604208533E-01 4.55483577414E-01 4.49344274426E-01 4.43188318385E-01 4.37017736751E-01 4.30834564314E-01 4.24640841875E-01 4.18438614923E-01 4.12229932309E-01 4.06016844925E-01 3.99801404385E-01 3.93585661718E-01 3.87371666084E-01 3.81161463500E-01 3.74957095605E-01 3.68760598464E-01 3.62574001408E-01 3.56399325944E-01 3.50238584718E-01 3.44093780569E-01 3.37966905664E-01 3.31859940743E-01 3.25774854472E-01 3.19713602935E-01 3.13678129257E-01 3.07670363383E-01 3.01692222020E-01 2.95745608741E-01 2.89832414262E-01 2.83954516881E-01 2.78113783082E-01 2.72312068269E-01 2.66551217620E-01 2.60833067012E-01 2.55159443972E-01 2.49532168570E-01 2.43953054198E-01 2.38423908094E-01 2.32946531514E-01 2.27522719382E-01 2.22154259258E-01 2.16842929423E-01 2.11590495855E-01 2.06398707882E-01 2.01269292250E-01 1.96203945392E-01 1.91204323686E-01 1.86272031577E-01 1.81408607555E-01 1.76615508142E-01 1.71894090312E-01 1.67245593060E-01 1.62671119189E-01 1.58171618706E-01 1.53747875442E-01 1.49400498505E-01 1.45129919933E-01 1.40936399293E-01 1.36820035172E-01 1.32780782619E-01 1.28818474784E-01 1.24932846615E-01 1.21123558347E-01 1.17390216931E-01 1.13732394050E-01 1.10149640079E-01 1.06641493916E-01 1.03207489056E-01 9.98471565222E-02 9.65600253957E-02 9.33456216388E-02 9.02034658293E-02 8.71330703046E-02 8.41339360886E-02 8.12055498661E-02 7.83473811766E-02 7.55588799318E-02 7.28394743064E-02 7.01885690197E-02 6.76055439978E-02 6.50897533963E-02 6.26405249526E-02 6.02571596347E-02 5.79389315533E-02 5.56850881038E-02 5.34948503104E-02 5.13674133432E-02 4.93019471856E-02 4.72975974304E-02 4.53534861869E-02 4.34687130812E-02 4.16423563386E-02 3.98734739340E-02 3.81611048010E-02 3.65042700908E-02 3.49019744735E-02 3.33532074746E-02 3.18569448414E-02 3.04121499357E-02 2.90177751450E-02 2.76727633127E-02 2.63760491806E-02 2.51265608417E-02 2.39232211996E-02 2.27649494320E-02 2.16506624528E-02 2.05792763707E-02 1.95497079369E-02 1.85608759778E-02 1.76117028039E-02 1.67011155881E-02 1.58280477011E-02 1.49914399958E-02 1.41902420257E-02 1.34234131881E-02 1.26899237776E-02 1.19887559410E-02 1.13189045243E-02 1.06793778069E-02 1.00691981220E-02 9.48740236553E-03 8.93304240321E-03 8.40518538564E-03 7.90291398836E-03 7.42532659354E-03 6.97153743176E-03 6.54067670127E-03 6.13189068041E-03 5.74434184589E-03 5.37720900612E-03 5.02968745540E-03 4.70098915099E-03 4.39034291234E-03 4.09699463900E-03 3.82020754223E-03 3.55926238381E-03 3.31345771533E-03 3.08211011083E-03 2.86455438615E-03 2.66014379889E-03 2.46825022348E-03 2.28826429692E-03 2.11959553146E-03 1.96167239129E-03 1.81394233152E-03 1.67587179789E-03 1.54694618689E-03 1.42666976617E-03 1.31456555584E-03 1.21017517173E-03 1.11305863184E-03 1.02279412771E-03 9.38977762646E-04 8.61223258866E-04 7.89161635770E-04 7.22440861760E-04 6.60725481949E-04 6.03696224230E-04 5.51049586155E-04 5.02497405044E-04 4.57766413729E-04 4.16597784283E-04 3.78746661988E-04 3.43981691766E-04 3.12084539152E-04 2.82849407843E-04 2.56082555705E-04 2.31601811045E-04 2.09236090830E-04 1.88824922408E-04 1.70217970200E-04 1.53274568674E-04 1.37863262833E-04 1.23861357303E-04 1.11154475024E-04 9.96361263949E-05 8.92072896687E-05 7.97760032962E-05 7.12569705071E-05 6.35711770370E-05 5.66455220769E-05 5.04124627888E-05 4.48096725972E-05 3.97797133827E-05 3.52697216301E-05 3.12311085191E-05 2.76192738830E-05 2.43933339084E-05 2.15158623937E-05 1.89526453468E-05 1.66724486539E-05 1.46467985257E-05 1.28497743898E-05 1.12578138794E-05 9.84952954203E-06 8.60553688138E-06 7.50829332836E-06 6.54194773260E-06 5.69219995931E-06 4.94617017645E-06 4.29227741974E-06 3.72012702920E-06 3.22040656095E-06 2.78478979133E-06 2.40584844781E-06 2.07697132240E-06 1.79229044949E-06 1.54661406106E-06 1.33246375737E-06 1.14609827730E-06 9.84179682266E-07 8.43734966888E-07 7.22120731750E-07 6.16990737548E-07 5.26266164087E-07 4.48108402635E-07 3.80894215392E-07 3.23193101663E-07 2.73746716387E-07 2.31450193003E-07 1.95335229227E-07 1.64554800964E-07 1.38369376359E-07 1.16134508831E-07 9.72896946836E-08 8.13483876697E-08 6.78890695061E-08 5.65472818712E-08 4.70085317668E-08 3.90019883007E-08 3.22948949039E-08 2.66876267343E-08 2.20093284967E-08 1.81140731478E-08 1.48774869110E-08 1.21937907253E-08 9.97321266761E-09 8.13973003550E-09 6.62910365043E-09 5.38717054796E-09 4.36836456733E-09 3.53443744482E-09 2.85335586328E-09 2.29835252434E-09 1.84711170042E-09 1.48107190310E-09 1.18483028405E-09 9.45635177250E-10 7.52954808924E-10 5.98111656118E-10 4.73973239544E-10 3.74691301485E-10 2.95482357700E-10 2.32443533873E-10 1.82398412673E-10 1.42768336960E-10 1.11465247257E-10 8.68026861138E-11 6.74220864188E-11 5.22318827086E-11 4.03573508022E-11 3.10993981363E-11 2.39008006570E-11 1.83186175992E-11 1.40019647645E-11 1.06730310206E-11 8.11291756834E-12 6.14956968477E-12 4.64813264054E-12 3.50320898656E-12 2.63266032976E-12 1.97265999643E-12 1.47375577418E-12 1.09774582903E-12 8.15207292346E-13 6.03547089581E-13 4.45469356837E-13 3.27774130649E-13 2.40418640069E-13 1.75786104950E-13 1.28117979073E-13 9.30745168545E-14 6.73957609208E-14 4.86408565364E-14 3.49882570969E-14 2.50831076015E-14 1.79210577338E-14 1.27601089734E-14 9.05396072478E-15 6.40178653675E-15 4.51052256716E-15 3.16665095138E-15 2.21516262187E-15 1.54392920118E-15 1.07213531232E-15 7.41747714211E-16 5.11247283766E-16 3.51040812839E-16 2.40115096409E-16 1.63606240483E-16 1.11040633410E-16 7.50669227113E-17 5.05455226337E-17 3.38974300008E-17 2.26403578679E-17 1.50596365261E-17 9.97567878632E-18 6.58035134329E-18 4.32231168556E-18 2.82699461842E-18 1.84101415732E-18 1.19369582900E-18 7.70576202230E-19 4.95226244030E-19 3.16838855016E-19 2.01790320144E-19 1.27929152570E-19 8.07283369499E-20 5.07048574583E-20 3.16971189039E-20 1.97204151822E-20 1.22100525685E-20 7.52321010522E-21 4.61266353298E-21 2.81411491786E-21 1.70825093936E-21 1.03171417996E-21 6.19930360332E-22 3.70578183618E-22 2.20367560041E-22 1.30353759097E-22 7.66980846222E-23 4.48856261672E-23 2.61257269486E-23 1.51232135095E-23 8.70583493237E-24 4.98360046177E-24 2.83673003143E-24 1.60549924484E-24 9.03430143315E-25 5.05412793811E-25 2.81086266208E-25 1.55399302410E-25 8.53981750051E-26 4.66457396180E-26 2.53228606849E-26 1.36623116743E-26 7.32519577047E-27 3.90274899106E-27 2.06609734091E-27 1.08675556438E-27 5.67918194087E-28 2.94838440680E-28 1.52054107180E-28 7.78930941496E-29 3.96330266117E-29 2.00282702820E-29 1.00514267247E-29 5.00933276175E-30 2.47895986116E-30 1.21805186375E-30 5.94206860614E-31 2.87775454223E-31 1.38351009917E-31 6.60224131716E-32 3.12714905826E-32 1.47001317792E-32 6.85766600791E-33 3.17453818826E-33 1.45814341017E-33 6.64509777047E-34 3.00434370484E-34 1.34744258296E-34 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 8.88653641214E-06 9.06605352908E-06 9.24919701697E-06 9.43604012867E-06 9.62665759663E-06 9.82112566280E-06 1.00195221091E-05 1.02219262886E-05 1.04284191571E-05 1.06390833056E-05 1.08540029934E-05 1.10732641814E-05 1.12969545672E-05 1.15251636194E-05 1.17579826139E-05 1.19955046700E-05 1.22378247879E-05 1.24850398867E-05 1.27372488431E-05 1.29945525306E-05 1.32570538604E-05 1.35248578221E-05 1.37980715260E-05 1.40768042456E-05 1.43611674615E-05 1.46512749060E-05 1.49472426083E-05 1.52491889413E-05 1.55572346684E-05 1.58715029922E-05 1.61921196038E-05 1.65192127326E-05 1.68529131980E-05 1.71933544612E-05 1.75406726793E-05 1.78950067589E-05 1.82564984123E-05 1.86252922137E-05 1.90015356572E-05 1.93853792157E-05 1.97769764010E-05 2.01764838252E-05 2.05840612634E-05 2.09998717173E-05 2.14240814806E-05 2.18568602054E-05 2.22983809699E-05 2.27488203475E-05 2.32083584779E-05 2.36771791383E-05 2.41554698174E-05 2.46434217903E-05 2.51412301944E-05 2.56490941083E-05 2.61672166305E-05 2.66958049608E-05 2.72350704835E-05 2.77852288513E-05 2.83465000718E-05 2.89191085953E-05 2.95032834044E-05 3.00992581059E-05 3.07072710233E-05 3.13275652930E-05 3.19603889607E-05 3.26059950808E-05 3.32646418176E-05 3.39365925479E-05 3.46221159669E-05 3.53214861953E-05 3.60349828883E-05 3.67628913482E-05 3.75055026374E-05 3.82631136955E-05 3.90360274574E-05 3.98245529742E-05 4.06290055371E-05 4.14497068029E-05 4.22869849226E-05 4.31411746726E-05 4.40126175879E-05 4.49016620991E-05 4.58086636709E-05 4.67339849447E-05 4.76779958828E-05 4.86410739163E-05 4.96236040959E-05 5.06259792456E-05 5.16486001192E-05 5.26918755608E-05 5.37562226675E-05 5.48420669561E-05 5.59498425331E-05 5.70799922675E-05 5.82329679682E-05 5.94092305634E-05 6.06092502856E-05 6.18335068584E-05 6.30824896883E-05 6.43566980597E-05 6.56566413345E-05 6.69828391551E-05 6.83358216516E-05 6.97161296533E-05 7.11243149046E-05 7.25609402849E-05 7.40265800333E-05 7.55218199773E-05 7.70472577668E-05 7.86035031118E-05 8.01911780266E-05 8.18109170764E-05 8.34633676317E-05 8.51491901253E-05 8.68690583161E-05 8.86236595576E-05 9.04136950718E-05 9.22398802287E-05 9.41029448313E-05 9.60036334066E-05 9.79427055022E-05 9.99209359886E-05 1.01939115369E-04 1.03998050091E-04 1.06098562875E-04 1.08241493031E-04 1.10427696805E-04 1.12658047709E-04 1.14933436876E-04 1.17254773414E-04 1.19622984763E-04 1.22039017071E-04 1.24503835566E-04 1.27018424940E-04 1.29583789746E-04 1.32200954790E-04 1.34870965545E-04 1.37594888565E-04 1.40373811907E-04 1.43208845569E-04 1.46101121925E-04 1.49051796179E-04 1.52062046826E-04 1.55133076116E-04 1.58266110535E-04 1.61462401292E-04 1.64723224815E-04 1.68049883259E-04 1.71443705025E-04 1.74906045285E-04 1.78438286520E-04 1.82041839072E-04 1.85718141703E-04 1.89468662163E-04 1.93294897779E-04 1.97198376040E-04 2.01180655214E-04 2.05243324957E-04 2.09388006949E-04 2.13616355536E-04 2.17930058385E-04 2.22330837153E-04 2.26820448171E-04 2.31400683139E-04 2.36073369837E-04 2.40840372849E-04 2.45703594298E-04 2.50664974606E-04 2.55726493256E-04 2.60890169580E-04 2.66158063555E-04 2.71532276622E-04 2.77014952512E-04 2.82608278098E-04 2.88314484260E-04 2.94135846764E-04 3.00074687163E-04 3.06133373716E-04 3.12314322320E-04 3.18619997467E-04 3.25052913218E-04 3.31615634191E-04 3.38310776576E-04 3.45141009170E-04 3.52109054423E-04 3.59217689516E-04 3.66469747456E-04 3.73868118190E-04 3.81415749744E-04 3.89115649388E-04 3.96970884812E-04 4.04984585342E-04 4.13159943165E-04 4.21500214586E-04 4.30008721312E-04 4.38688851752E-04 4.47544062352E-04 4.56577878952E-04 4.65793898169E-04 4.75195788808E-04 4.84787293305E-04 4.94572229190E-04 5.04554490586E-04 5.14738049736E-04 5.25126958555E-04 5.35725350219E-04 5.46537440783E-04 5.57567530826E-04 5.68820007138E-04 5.80299344431E-04 5.92010107086E-04 6.03956950938E-04 6.16144625088E-04 6.28577973763E-04 6.41261938194E-04 6.54201558552E-04 6.67401975899E-04 6.80868434202E-04 6.94606282359E-04 7.08620976289E-04 7.22918081047E-04 7.37503272983E-04 7.52382341950E-04 7.67561193545E-04 7.83045851396E-04 7.98842459502E-04 8.14957284605E-04 8.31396718613E-04 8.48167281076E-04 8.65275621699E-04 8.82728522911E-04 9.00532902480E-04 9.18695816178E-04 9.37224460501E-04 9.56126175433E-04 9.75408447272E-04 9.95078911507E-04 1.01514535574E-03 1.03561572269E-03 1.05649811321E-03 1.07780078942E-03 1.09953217784E-03 1.12170087261E-03 1.14431563881E-03 1.16738541576E-03 1.19091932042E-03 1.21492665091E-03 1.23941689000E-03 1.26439970874E-03 1.28988497009E-03 1.31588273271E-03 1.34240325473E-03 1.36945699766E-03 1.39705463030E-03 1.42520703279E-03 1.45392530072E-03 1.48322074928E-03 1.51310491753E-03 1.54358957273E-03 1.57468671474E-03 1.60640858052E-03 1.63876764870E-03 1.67177664425E-03 1.70544854319E-03 1.73979657748E-03 1.77483423985E-03 1.81057528891E-03 1.84703375414E-03 1.88422394117E-03 1.92216043700E-03 1.96085811542E-03 2.00033214244E-03 2.04059798188E-03 2.08167140108E-03 2.12356847659E-03 2.16630560010E-03 2.20989948441E-03 2.25436716948E-03 2.29972602867E-03 2.34599377497E-03 2.39318846746E-03 2.44132851780E-03 2.49043269685E-03 2.54052014144E-03 2.59161036120E-03 2.64372324555E-03 2.69687907080E-03 2.75109850735E-03 2.80640262701E-03 2.86281291050E-03 2.92035125499E-03 2.97903998185E-03 3.03890184443E-03 3.09996003610E-03 3.16223819826E-03 3.22576042863E-03 3.29055128960E-03 3.35663581670E-03 3.42403952725E-03 3.49278842912E-03 3.56290902964E-03 3.63442834465E-03 3.70737390767E-03 3.78177377927E-03 3.85765655649E-03 3.93505138248E-03 4.01398795629E-03 4.09449654273E-03 4.17660798248E-03 4.26035370225E-03 4.34576572515E-03 4.43287668123E-03 4.52171981808E-03 4.61232901167E-03 4.70473877731E-03 4.79898428077E-03 4.89510134952E-03 4.99312648416E-03 5.09309687002E-03 5.19505038884E-03 5.29902563068E-03 5.40506190596E-03 5.51319925763E-03 5.62347847350E-03 5.73594109876E-03 5.85062944860E-03 5.96758662104E-03 6.08685650981E-03 6.20848381752E-03 6.33251406884E-03 6.45899362390E-03 6.58796969185E-03 6.71949034451E-03 6.85360453017E-03 6.99036208755E-03 7.12981375991E-03 7.27201120922E-03 7.41700703054E-03 7.56485476649E-03 7.71560892182E-03 7.86932497814E-03 8.02605940874E-03 8.18586969354E-03 8.34881433408E-03 8.51495286872E-03 8.68434588780E-03 8.85705504901E-03 9.03314309276E-03 9.21267385767E-03 9.39571229606E-03 9.58232448959E-03 9.77257766488E-03 9.96654020918E-03 1.01642816861E-02 1.03658728514E-02 1.05713856686E-02 1.07808933249E-02 1.09944702467E-02 1.12121921155E-02 1.14341358835E-02 1.16603797894E-02 1.18910033735E-02 1.21260874937E-02 1.23657143405E-02 1.26099674525E-02 1.28589317316E-02 1.31126934576E-02 1.33713403035E-02 1.36349613498E-02 1.39036470992E-02 1.41774894906E-02 1.44565819130E-02 1.47410192195E-02 1.50308977404E-02 1.53263152960E-02 1.56273712101E-02 1.59341663213E-02 1.62468029956E-02 1.65653851377E-02 1.68900182016E-02 1.72208092016E-02 1.75578667218E-02 1.79013009256E-02 1.82512235643E-02 1.86077479852E-02 1.89709891392E-02 1.93410635869E-02 1.97180895048E-02 2.01021866901E-02 2.04934765650E-02 2.08920821795E-02 2.12981282142E-02 2.17117409809E-02 2.21330484227E-02 2.25621801134E-02 2.29992672549E-02 2.34444426735E-02 2.38978408156E-02 2.43595977406E-02 2.48298511142E-02 2.53087401984E-02 2.57964058408E-02 2.62929904625E-02 2.67986380435E-02 2.73134941067E-02 2.78377056999E-02 2.83714213759E-02 2.89147911707E-02 2.94679665789E-02 3.00311005274E-02 3.06043473469E-02 3.11878627406E-02 3.17818037501E-02 3.23863287196E-02 3.30015972566E-02 3.36277701899E-02 3.42650095248E-02 3.49134783956E-02 3.55733410139E-02 3.62447626146E-02 3.69279093987E-02 3.76229484713E-02 3.83300477772E-02 3.90493760326E-02 3.97811026523E-02 4.05253976736E-02 4.12824316755E-02 4.20523756947E-02 4.28354011355E-02 4.36316796772E-02 4.44413831753E-02 4.52646835587E-02 4.61017527221E-02 4.69527624128E-02 4.78178841130E-02 4.86972889165E-02 4.95911473996E-02 5.04996294874E-02 5.14229043137E-02 5.23611400751E-02 5.33145038796E-02 5.42831615887E-02 5.52672776538E-02 5.62670149456E-02 5.72825345780E-02 5.83139957247E-02 5.93615554295E-02 6.04253684098E-02 6.15055868536E-02 6.26023602089E-02 6.37158349666E-02 6.48461544366E-02 6.59934585158E-02 6.71578834501E-02 6.83395615880E-02 6.95386211277E-02 7.07551858570E-02 7.19893748850E-02 7.32413023675E-02 7.45110772244E-02 7.57988028503E-02 7.71045768175E-02 7.84284905721E-02 7.97706291233E-02 8.11310707250E-02 8.25098865511E-02 8.39071403644E-02 8.53228881781E-02 8.67571779121E-02 8.82100490421E-02 8.96815322438E-02 9.11716490312E-02 9.26804113890E-02 9.42078214019E-02 9.57538708769E-02 9.73185409639E-02 9.89018017706E-02 1.00503611976E-01 1.02123918439E-01 1.03762655809E-01 1.05419746128E-01 1.07095098440E-01 1.08788608393E-01 1.10500157847E-01 1.12229614481E-01 1.13976831401E-01 1.15741646749E-01 1.17523883327E-01 1.19323348209E-01 1.21139832373E-01 1.22973110332E-01 1.24822939774E-01 1.26689061217E-01 1.28571197662E-01 1.30469054273E-01 1.32382318055E-01 1.34310657558E-01 1.36253722585E-01 1.38211143930E-01 1.40182533121E-01 1.42167482191E-01 1.44165563470E-01 1.46176329394E-01 1.48199312344E-01 1.50234024507E-01 1.52279957769E-01 1.54336583631E-01 1.56403353159E-01 1.58479696969E-01 1.60565025237E-01 1.62658727756E-01 1.64760174018E-01 1.66868713345E-01 1.68983675052E-01 1.71104368656E-01 1.73230084126E-01 1.75360092177E-01 1.77493644607E-01 1.79629974689E-01 1.81768297597E-01 1.83907810893E-01 1.86047695054E-01 1.88187114056E-01 1.90325216002E-01 1.92461133803E-01 1.94593985914E-01 1.96722877113E-01 1.98846899337E-01 2.00965132565E-01 2.03076645749E-01 2.05180497798E-01 2.07275738608E-01 2.09361410132E-01 2.11436547501E-01 2.13500180185E-01 2.15551333191E-01 2.17589028304E-01 2.19612285354E-01 2.21620123520E-01 2.23611562657E-01 2.25585624651E-01 2.27541334788E-01 2.29477723138E-01 2.31393825952E-01 2.33288687057E-01 2.35161359257E-01 2.37010905716E-01 2.38836401339E-01 2.40636934124E-01 2.42411606491E-01 2.44159536578E-01 2.45879859492E-01 2.47571728519E-01 2.49234316268E-01 2.50866815766E-01 2.52468441466E-01 2.54038430194E-01 2.55576041996E-01 2.57080560902E-01 2.58551295585E-01 2.59987579915E-01 2.61388773399E-01 2.62754261500E-01 2.64083455834E-01 2.65375794232E-01 2.66630740666E-01 2.67847785039E-01 2.69026442828E-01 2.70166254583E-01 2.71266785278E-01 2.72327623510E-01 2.73348380557E-01 2.74328689282E-01 2.75268202892E-01 2.76166593564E-01 2.77023550923E-01 2.77838780398E-01 2.78612001447E-01 2.79342945675E-01 2.80031354833E-01 2.80676978737E-01 2.81279573091E-01 2.81838897242E-01 2.82354711881E-01 2.82826776696E-01 2.83254848001E-01 2.83638676344E-01 2.83978004129E-01 2.84272563249E-01 2.84522072749E-01 2.84726236548E-01 2.84884741209E-01 2.84997253793E-01 2.85063419793E-01 2.85082861156E-01 2.85055174411E-01 2.84979928891E-01 2.84856665054E-01 2.84684892904E-01 2.84464090489E-01 2.84193702478E-01 2.83873138780E-01 2.83501773205E-01 2.83078942107E-01 2.82603943000E-01 2.82076033095E-01 2.81494427710E-01 2.80858298511E-01 2.80166771525E-01 2.79418924789E-01 2.78613784534E-01 2.77750514114E-01 2.76829030296E-01 2.75849473151E-01 2.74812021565E-01 2.73716894085E-01 2.72564348503E-01 2.71354681157E-01 2.70088226101E-01 2.68765365681E-01 2.67386568326E-01 2.65952361569E-01 2.64463321590E-01 2.62920073219E-01 2.61323289929E-01 2.59673693775E-01 2.57972055252E-01 2.56219193083E-01 2.54415973932E-01 2.52563312044E-01 2.50662168801E-01 2.48713552209E-01 2.46718516299E-01 2.44678160456E-01 2.42593628658E-01 2.40466108650E-01 2.38296831030E-01 2.36087068250E-01 2.33838133555E-01 2.31551379830E-01 2.29228198373E-01 2.26870017599E-01 2.24478301659E-01 2.22054548994E-01 2.19600290817E-01 2.17117089519E-01 2.14606537019E-01 2.12070253041E-01 2.09509883332E-01 2.06927097821E-01 2.04323588726E-01 2.01701068600E-01 1.99061268335E-01 1.96405935119E-01 1.93736830346E-01 1.91055727535E-01 1.88364410503E-01 1.85664515808E-01 1.82957995984E-01 1.80246650644E-01 1.77532280836E-01 1.74816686422E-01 1.72101663766E-01 1.69389003458E-01 1.66680488068E-01 1.63977890154E-01 1.61282969607E-01 1.58597470832E-01 1.55923121207E-01 1.53261629210E-01 1.50614681923E-01 1.47983942862E-01 1.45371049865E-01 1.42777613029E-01 1.40205212679E-01 1.37655397400E-01 1.35129682106E-01 1.32629546173E-01 1.30156431625E-01 1.27711741387E-01 1.25296837599E-01 1.22913039999E-01 1.20561624378E-01 1.18243821112E-01 1.15960813769E-01 1.13713737794E-01 1.11503679283E-01 1.09331673839E-01 1.07198705521E-01 1.05105705881E-01 1.03053553097E-01 1.01043071210E-01 9.90750294555E-02 9.71501417016E-02 9.52690659990E-02 9.34324042399E-02 9.16407019345E-02 8.98944481082E-02 8.81940753237E-02 8.65399598343E-02 8.49324218715E-02 8.33717260756E-02 8.18580820732E-02 8.03916452080E-02 7.89725174341E-02 7.76007483752E-02 7.62763365596E-02 7.49992308363E-02 7.37693319787E-02 7.25864944816E-02 7.14505285557E-02 7.03612023210E-02 6.93182442000E-02 6.83213455043E-02 6.73701632078E-02 6.64643228887E-02 6.56034218184E-02 6.47870321628E-02 6.40147042503E-02 6.32859698468E-02 6.26003453564E-02 6.19573348501E-02 6.13564327975E-02 6.07971263487E-02 6.02788969858E-02 5.98012213341E-02 5.93635708944E-02 5.89654104451E-02 5.86061948612E-02 5.82853641305E-02 5.80023364210E-02 5.77564991896E-02 5.75471985198E-02 5.73737271442E-02 5.72353119117E-02 5.71311017516E-02 5.70601573951E-02 5.70214441470E-02 5.70138288052E-02 5.70360813870E-02 5.70868817163E-02 5.71648302768E-02 5.72684622062E-02 5.73962630002E-02 5.75466844700E-02 5.77181597096E-02 5.79091161874E-02 5.81179864778E-02 5.83432165077E-02 5.85832714605E-02 5.88366396432E-02 5.91018346958E-02 5.93773965313E-02 5.96618913561E-02 5.99539110700E-02 6.02520722807E-02 6.05550151123E-02 6.08614019378E-02 6.11699161224E-02 6.14792608385E-02 6.17881579836E-02 6.20953472213E-02 6.23995851519E-02 6.26996446105E-02 6.29943140900E-02 6.32823972792E-02 6.35627127112E-02 6.38340935114E-02 6.40953872420E-02 6.43454558347E-02 6.45831756117E-02 6.48074373907E-02 6.50171466786E-02 6.52112239529E-02 6.53886050416E-02 6.55482416057E-02 6.56891017384E-02 6.58101706952E-02 6.59104517706E-02 6.59889673453E-02 6.60447601261E-02 6.60768946085E-02 6.60844587935E-02 6.60665661934E-02 6.60223581650E-02 6.59510066102E-02 6.58517170823E-02 6.57237323360E-02 6.55663363528E-02 6.53788588630E-02 6.51606803727E-02 6.49112376840E-02 6.46300298700E-02 6.43166246364E-02 6.39706649656E-02 6.35918759005E-02 6.31800712897E-02 6.27351602797E-02 6.22571533178E-02 6.17461674164E-02 6.12024304340E-02 6.06262841509E-02 6.00181859585E-02 5.93787090357E-02 5.87085409526E-02 5.80084807141E-02 5.72794343197E-02 5.65224089811E-02 5.57385061818E-02 5.49289137959E-02 5.40948974970E-02 5.32377916885E-02 5.23589901719E-02 5.14599367510E-02 5.05421159383E-02 4.96070439038E-02 4.86562597739E-02 4.76913173628E-02 4.67137773910E-02 4.57252002298E-02 4.47271391863E-02 4.37211343390E-02 4.27087069145E-02 4.16913541960E-02 4.06705449443E-02 3.96477153100E-02 3.86242652140E-02 3.76015551706E-02 3.65809035390E-02 3.55635841245E-02 3.45508242123E-02 3.35438028996E-02 3.25436497601E-02 3.15514438034E-02 3.05682127099E-02 2.95949323186E-02 2.86325263468E-02 2.76818663238E-02 2.67437717174E-02 2.58190102362E-02 2.49082982896E-02 2.40123015888E-02 2.31316358719E-02 2.22668677392E-02 2.14185155813E-02 2.05870505893E-02 1.97728978307E-02 1.89764373805E-02 1.81980054961E-02 1.74378958235E-02 1.66963606270E-02 1.59736120330E-02 1.52698232804E-02 1.45851299694E-02 1.39196313067E-02 1.32733913380E-02 1.26464401688E-02 1.20387751704E-02 1.14503621831E-02 1.08811366469E-02 1.03310047737E-02 9.79984468808E-03 9.28750755306E-03 8.79381868679E-03 8.31857867305E-03 7.86156446973E-03 7.42253051926E-03 7.00120986490E-03 6.59731527690E-03 6.21054039181E-03 5.84056086825E-03 5.48703556137E-03 5.14960771775E-03 4.82790619166E-03 4.52154668261E-03 4.23013299326E-03 3.95325830592E-03 3.69050647474E-03 3.44145333009E-03 3.20566799056E-03 2.98271417770E-03 2.77215152756E-03 2.57353689299E-03 2.38642563028E-03 2.21037286324E-03 2.04493471820E-03 1.88966952317E-03 1.74413896463E-03 1.60790919594E-03 1.48055189157E-03 1.36164524193E-03 1.25077488431E-03 1.14753476581E-03 1.05152793514E-03 9.62367260691E-04 8.79676073082E-04 8.03088731188E-04 7.32251111239E-04 6.66821019397E-04 6.06468528835E-04 5.50876242946E-04 4.99739486907E-04 4.52766430286E-04 4.09678143872E-04 3.70208594264E-04 3.34104580069E-04 3.01125613838E-04 2.71043754032E-04 2.43643391468E-04 2.18720994732E-04 1.96084819114E-04 1.75554583539E-04 1.56961119932E-04 1.40145999314E-04 1.24961138792E-04 1.11268393417E-04 9.89391366738E-05 8.78538331559E-05 7.79016067230E-05 6.89798071904E-05 6.09935783424E-05 5.38554297961E-05 4.74848149802E-05 4.18077172323E-05 3.67562457683E-05 3.22682430271E-05 2.82869046619E-05 2.47604132254E-05 2.16415863838E-05 1.88875403008E-05 1.64593686487E-05 1.43218375385E-05 1.24430965080E-05 1.07944055725E-05 9.34987821941E-06 8.08624012296E-06 6.98260326137E-06 6.02025504043E-06 5.18246196030E-06 4.45428730808E-06 3.82242231470E-06 3.27503018166E-06 2.80160235878E-06 2.39282643485E-06 2.04046166051E-06 1.73720284055E-06 1.47662540953E-06 1.25308577744E-06 1.06163393408E-06 8.97935434602E-07 7.58201226504E-07 6.39124643058E-07 5.37824933152E-07 4.51796741474E-07 3.78864994798E-07 3.17144690237E-07 2.65005119518E-07 2.21038099609E-07 1.84029814407E-07 1.52935904612E-07 1.26859473464E-07 1.05031704658E-07 8.67948155918E-08 7.15870941107E-08 5.89297902117E-08 4.84156557693E-08 3.96989453499E-08 3.24867096282E-08 2.65312299067E-08 2.16234578231E-08 1.75873385976E-08 1.42749091986E-08 1.15620746602E-08 9.34497655273E-09 7.53687735788E-09 6.06549330435E-09 4.87071615266E-09 3.90267154287E-09 3.12006790278E-09 2.48879561903E-09 1.98074125695E-09 1.57278613326E-09 1.24596255107E-09 9.84744546537E-10 7.76453118492E-10 6.10758656107E-10 4.79265686595E-10 3.75167168874E-10 2.92957394255E-10 2.28194151040E-10 1.77302193839E-10 1.37411255322E-10 1.06222870317E-10 8.19011698488E-11 6.29835639527E-11 4.83078830210E-11 3.69531025034E-11 2.81912476684E-11 2.14484751972E-11 1.62736665393E-11 1.23131529670E-11 9.29043175264E-12 6.98993354586E-12 5.24406863060E-12 3.92291931984E-12 2.92606163165E-12 2.17609531083E-12 1.61354041028E-12 1.19282375546E-12 8.79132006562E-13 6.45951677160E-13 4.73152031752E-13 3.45495669992E-13 2.51484992002E-13 1.82471611275E-13 1.31970961284E-13 9.51365109095E-14 6.83577268703E-14 4.89536638997E-14 3.49402080783E-14 2.48538585125E-14 1.76187629398E-14 1.24467313609E-14 8.76230651847E-15 6.14680652369E-15 4.29668212844E-15 2.99263627118E-15 2.07680616925E-15 1.43596366068E-15 9.89191472489E-16 6.78876105561E-16 4.64149172846E-16 3.16129502557E-16 2.14484637756E-16 1.44955345617E-16 9.75803025176E-17 6.54278731831E-17 4.36937022175E-17 2.90611510078E-17 1.92498383998E-17 1.26982518239E-17 8.34152619672E-18 5.45649737827E-18 3.55411417459E-18 2.30504856719E-18 1.48847896099E-18 9.56979278591E-19 6.12553553801E-19 3.90349658001E-19 2.47640507331E-19 1.56402374877E-19 9.83385679638E-20 6.15579439658E-20 3.83681556987E-20 2.38163189356E-20 1.47284786115E-20 9.08038004786E-21 5.58724563444E-21 3.43762641861E-21 2.10453836645E-21 1.28194835020E-21 TDDFPT/Examples/pseudo/H.pbe-van_ak.UPF0000644000175000017500000023436212341371476015767 0ustar mbamba Generated using Vanderbilt code, version 7 3 4 Author: unknown Generation date: 4 3 5 Automatically converted from original format 0 The Pseudo was generated with a Non-Relativistic Calculation 8.00000000000E-01 Local Potential cutoff radius nl pn l occ Rcut Rcut US E pseu 1S 1 0 1.00 10.00000000000 0.80000000000 -0.47719090823 0 Version Number H Element US Ultrasoft pseudopotential F Nonlinear Core Correction SLA PW PBE PBE PBE Exchange-Correlation functional 1.00000000000 Z valence -0.91748955061 Total energy 0.0000000 0.0000000 Suggested cutoff for wfc and rho 0 Max angular momentum component 615 Number of points in mesh 1 1 Number of Wavefunctions, Number of Projectors Wavefunctions nl l occ 1S 0 1.00 0.00000000000E+00 4.23708090800E-05 8.54658880079E-05 1.29297617166E-04 1.73878588562E-04 2.19221609446E-04 2.65339705991E-04 3.12246127033E-04 3.59954347880E-04 4.08478074179E-04 4.57831245860E-04 5.08028041132E-04 5.59082880565E-04 6.11010431224E-04 6.63825610891E-04 7.17543592346E-04 7.72179807723E-04 8.27749952951E-04 8.84269992258E-04 9.41756162756E-04 1.00022497911E-03 1.05969323828E-03 1.12017802435E-03 1.18169671342E-03 1.24426697862E-03 1.30790679519E-03 1.37263444560E-03 1.43846852486E-03 1.50542794582E-03 1.57353194464E-03 1.64280008627E-03 1.71325227011E-03 1.78490873571E-03 1.85779006859E-03 1.93191720613E-03 2.00731144364E-03 2.08399444042E-03 2.16198822601E-03 2.24131520651E-03 2.32199817104E-03 2.40406029824E-03 2.48752516298E-03 2.57241674309E-03 2.65875942630E-03 2.74657801717E-03 2.83589774429E-03 2.92674426749E-03 3.01914368522E-03 3.11312254204E-03 3.20870783626E-03 3.30592702769E-03 3.40480804551E-03 3.50537929633E-03 3.60766967233E-03 3.71170855954E-03 3.81752584634E-03 3.92515193197E-03 4.03461773533E-03 4.14595470383E-03 4.25919482242E-03 4.37437062280E-03 4.49151519274E-03 4.61066218562E-03 4.73184583006E-03 4.85510093978E-03 4.98046292358E-03 5.10796779554E-03 5.23765218533E-03 5.36955334878E-03 5.50370917854E-03 5.64015821498E-03 5.77893965726E-03 5.92009337461E-03 6.06365991777E-03 6.20968053062E-03 6.35819716206E-03 6.50925247803E-03 6.66288987383E-03 6.81915348648E-03 6.97808820751E-03 7.13973969578E-03 7.30415439064E-03 7.47137952525E-03 7.64146314016E-03 7.81445409709E-03 7.99040209300E-03 8.16935767435E-03 8.35137225160E-03 8.53649811404E-03 8.72478844472E-03 8.91629733583E-03 9.11107980416E-03 9.30919180695E-03 9.51069025794E-03 9.71563304373E-03 9.92407904042E-03 1.01360881305E-02 1.03517212201E-02 1.05710402565E-02 1.07941082456E-02 1.10209892708E-02 1.12517485104E-02 1.14864522572E-02 1.17251679369E-02 1.19679641281E-02 1.22149105813E-02 1.24660782395E-02 1.27215392582E-02 1.29813670266E-02 1.32456361880E-02 1.35144226619E-02 1.37878036655E-02 1.40658577358E-02 1.43486647524E-02 1.46363059602E-02 1.49288639930E-02 1.52264228971E-02 1.55290681554E-02 1.58368867121E-02 1.61499669973E-02 1.64683989531E-02 1.67922740588E-02 1.71216853574E-02 1.74567274824E-02 1.77974966849E-02 1.81440908614E-02 1.84966095816E-02 1.88551541174E-02 1.92198274716E-02 1.95907344078E-02 1.99679814805E-02 2.03516770654E-02 2.07419313909E-02 2.11388565693E-02 2.15425666298E-02 2.19531775503E-02 2.23708072915E-02 2.27955758302E-02 2.32276051943E-02 2.36670194974E-02 2.41139449748E-02 2.45685100194E-02 2.50308452192E-02 2.55010833939E-02 2.59793596339E-02 2.64658113388E-02 2.69605782567E-02 2.74638025245E-02 2.79756287089E-02 2.84962038476E-02 2.90256774917E-02 2.95642017489E-02 3.01119313267E-02 3.06690235772E-02 3.12356385422E-02 3.18119389993E-02 3.23980905084E-02 3.29942614595E-02 3.36006231210E-02 3.42173496888E-02 3.48446183366E-02 3.54826092665E-02 3.61315057610E-02 3.67914942355E-02 3.74627642918E-02 3.81455087729E-02 3.88399238181E-02 3.95462089193E-02 4.02645669786E-02 4.09952043664E-02 4.17383309807E-02 4.24941603073E-02 4.32629094814E-02 4.40447993498E-02 4.48400545342E-02 4.56489034962E-02 4.64715786023E-02 4.73083161912E-02 4.81593566414E-02 4.90249444405E-02 4.99053282549E-02 5.08007610019E-02 5.17114999221E-02 5.26378066531E-02 5.35799473048E-02 5.45381925362E-02 5.55128176324E-02 5.65041025845E-02 5.75123321694E-02 5.85377960319E-02 5.95807887680E-02 6.06416100093E-02 6.17205645093E-02 6.28179622306E-02 6.39341184344E-02 6.50693537708E-02 6.62239943709E-02 6.73983719406E-02 6.85928238560E-02 6.98076932598E-02 7.10433291606E-02 7.23000865326E-02 7.35783264180E-02 7.48784160303E-02 7.62007288601E-02 7.75456447822E-02 7.89135501651E-02 8.03048379814E-02 8.17199079213E-02 8.31591665069E-02 8.46230272093E-02 8.61119105675E-02 8.76262443088E-02 8.91664634719E-02 9.07330105322E-02 9.23263355281E-02 9.39468961911E-02 9.55951580770E-02 9.72715946995E-02 9.89766876664E-02 1.00710926818E-01 1.02474810367E-01 1.04268845045E-01 1.06093546241E-01 1.07949438157E-01 1.09837053956E-01 1.11756935912E-01 1.13709635571E-01 1.15695713906E-01 1.17715741477E-01 1.19770298601E-01 1.21859975512E-01 1.23985372533E-01 1.26147100250E-01 1.28345779685E-01 1.30582042477E-01 1.32856531060E-01 1.35169898851E-01 1.37522810436E-01 1.39915941761E-01 1.42349980326E-01 1.44825625383E-01 1.47343588137E-01 1.49904591951E-01 1.52509372551E-01 1.55158678239E-01 1.57853270111E-01 1.60593922271E-01 1.63381422054E-01 1.66216570256E-01 1.69100181359E-01 1.72033083770E-01 1.75016120055E-01 1.78050147181E-01 1.81136036767E-01 1.84274675329E-01 1.87466964536E-01 1.90713821473E-01 1.94016178897E-01 1.97374985513E-01 2.00791206240E-01 2.04265822493E-01 2.07799832461E-01 2.11394251398E-01 2.15050111910E-01 2.18768464255E-01 2.22550376645E-01 2.26396935548E-01 2.30309246008E-01 2.34288431955E-01 2.38335636532E-01 2.42452022423E-01 2.46638772186E-01 2.50897088593E-01 2.55228194977E-01 2.59633335579E-01 2.64113775912E-01 2.68670803119E-01 2.73305726347E-01 2.78019877119E-01 2.82814609719E-01 2.87691301581E-01 2.92651353685E-01 2.97696190957E-01 3.02827262682E-01 3.08046042917E-01 3.13354030916E-01 3.18752751563E-01 3.24243755804E-01 3.29828621100E-01 3.35508951873E-01 3.41286379974E-01 3.47162565144E-01 3.53139195500E-01 3.59217988010E-01 3.65400688995E-01 3.71689074624E-01 3.78084951430E-01 3.84590156823E-01 3.91206559624E-01 3.97936060596E-01 4.04780592996E-01 4.11742123125E-01 4.18822650896E-01 4.26024210408E-01 4.33348870529E-01 4.40798735492E-01 4.48375945500E-01 4.56082677337E-01 4.63921145000E-01 4.71893600329E-01 4.80002333654E-01 4.88249674459E-01 4.96637992045E-01 5.05169696214E-01 5.13847237958E-01 5.22673110168E-01 5.31649848345E-01 5.40780031334E-01 5.50066282059E-01 5.59511268280E-01 5.69117703359E-01 5.78888347038E-01 5.88826006236E-01 5.98933535848E-01 6.09213839572E-01 6.19669870742E-01 6.30304633172E-01 6.41121182023E-01 6.52122624681E-01 6.63312121648E-01 6.74692887450E-01 6.86268191559E-01 6.98041359338E-01 7.10015772989E-01 7.22194872529E-01 7.34582156779E-01 7.47181184366E-01 7.59995574745E-01 7.73029009244E-01 7.86285232117E-01 7.99768051619E-01 8.13481341103E-01 8.27429040133E-01 8.41615155612E-01 8.56043762936E-01 8.70719007167E-01 8.85645104216E-01 9.00826342063E-01 9.16267081984E-01 9.31971759805E-01 9.47944887176E-01 9.64191052866E-01 9.80714924086E-01 9.97521247823E-01 1.01461485221E+00 1.03200064791E+00 1.04968362952E+00 1.06766887702E+00 1.08596155723E+00 1.10456692528E+00 1.12349032612E+00 1.14273719610E+00 1.16231306446E+00 1.18222355496E+00 1.20247438752E+00 1.22307137979E+00 1.24402044890E+00 1.26532761311E+00 1.28699899356E+00 1.30904081601E+00 1.33145941266E+00 1.35426122392E+00 1.37745280033E+00 1.40104080437E+00 1.42503201242E+00 1.44943331668E+00 1.47425172719E+00 1.49949437379E+00 1.52516850821E+00 1.55128150612E+00 1.57784086928E+00 1.60485422770E+00 1.63232934177E+00 1.66027410458E+00 1.68869654410E+00 1.71760482557E+00 1.74700725376E+00 1.77691227542E+00 1.80732848170E+00 1.83826461057E+00 1.86972954939E+00 1.90173233742E+00 1.93428216846E+00 1.96738839342E+00 2.00106052311E+00 2.03530823085E+00 2.07014135536E+00 2.10556990352E+00 2.14160405327E+00 2.17825415652E+00 2.21553074213E+00 2.25344451895E+00 2.29200637888E+00 2.33122739998E+00 2.37111884970E+00 2.41169218808E+00 2.45295907105E+00 2.49493135380E+00 2.53762109414E+00 2.58104055601E+00 2.62520221299E+00 2.67011875186E+00 2.71580307628E+00 2.76226831047E+00 2.80952780299E+00 2.85759513057E+00 2.90648410204E+00 2.95620876224E+00 3.00678339612E+00 3.05822253278E+00 3.11054094969E+00 3.16375367692E+00 3.21787600146E+00 3.27292347160E+00 3.32891190142E+00 3.38585737531E+00 3.44377625260E+00 3.50268517227E+00 3.56260105770E+00 3.62354112158E+00 3.68552287080E+00 3.74856411152E+00 3.81268295426E+00 3.87789781914E+00 3.94422744112E+00 4.01169087542E+00 4.08030750298E+00 4.15009703602E+00 4.22107952372E+00 4.29327535800E+00 4.36670527930E+00 4.44139038262E+00 4.51735212356E+00 4.59461232444E+00 4.67319318063E+00 4.75311726689E+00 4.83440754387E+00 4.91708736467E+00 5.00118048163E+00 5.08671105305E+00 5.17370365023E+00 5.26218326445E+00 5.35217531419E+00 5.44370565243E+00 5.53680057406E+00 5.63148682344E+00 5.72779160212E+00 5.82574257658E+00 5.92536788625E+00 6.02669615156E+00 6.12975648214E+00 6.23457848524E+00 6.34119227419E+00 6.44962847707E+00 6.55991824551E+00 6.67209326361E+00 6.78618575710E+00 6.90222850253E+00 7.02025483675E+00 7.14029866643E+00 7.26239447784E+00 7.38657734675E+00 7.51288294850E+00 7.64134756823E+00 7.77200811135E+00 7.90490211410E+00 8.04006775436E+00 8.17754386261E+00 8.31736993306E+00 8.45958613504E+00 8.60423332451E+00 8.75135305582E+00 8.90098759361E+00 9.05317992499E+00 9.20797377188E+00 9.36541360354E+00 9.52554464941E+00 9.68841291202E+00 9.85406518028E+00 1.00225490429E+01 1.01939129020E+01 1.03682059871E+01 1.05454783692E+01 1.07257809753E+01 1.09091656029E+01 1.10956849347E+01 1.12853925542E+01 1.14783429606E+01 1.16745915850E+01 1.18741948058E+01 1.20772099650E+01 1.22836953850E+01 1.24937103852E+01 1.27073152986E+01 1.29245714900E+01 1.31455413727E+01 1.33702884272E+01 1.35988772189E+01 1.38313734170E+01 1.40678438131E+01 1.43083563406E+01 1.45529800941E+01 1.48017853493E+01 1.50548435831E+01 1.53122274942E+01 1.55740110241E+01 1.58402693780E+01 1.61110790470E+01 1.63865178292E+01 1.66666648531E+01 1.69516005993E+01 1.72414069245E+01 1.75361670844E+01 1.78359657578E+01 1.81408890711E+01 1.84510246229E+01 1.87664615091E+01 1.90872903487E+01 1.94136033095E+01 1.97454941350E+01 2.00830581710E+01 2.04263923931E+01 2.07755954345E+01 2.11307676145E+01 2.14920109673E+01 2.18594292711E+01 2.22331280780E+01 2.26132147444E+01 2.29997984620E+01 2.33929902887E+01 2.37929031809E+01 2.41996520259E+01 2.46133536747E+01 2.50341269758E+01 2.54620928093E+01 2.58973741215E+01 2.63400959602E+01 2.67903855108E+01 2.72483721329E+01 2.77141873971E+01 2.81879651232E+01 2.86698414183E+01 2.91599547161E+01 2.96584458168E+01 3.01654579271E+01 3.06811367018E+01 3.12056302856E+01 3.17390893551E+01 3.22816671629E+01 3.28335195812E+01 3.33948051463E+01 3.39656851048E+01 3.45463234596E+01 3.51368870166E+01 3.57375454334E+01 3.63484712676E+01 3.69698400263E+01 3.76018302168E+01 3.82446233975E+01 3.88984042306E+01 3.95633605346E+01 4.02396833386E+01 4.09275669370E+01 4.16272089455E+01 4.23388103578E+01 4.30625756030E+01 4.37987126050E+01 4.45474328418E+01 4.53089514060E+01 4.60834870673E+01 4.68712623348E+01 4.76725035210E+01 4.84874408072E+01 4.93163083088E+01 5.01593441437E+01 5.10167904996E+01 5.18888937042E+01 5.27759042961E+01 5.36780770961E+01 5.45956712810E+01 5.55289504579E+01 5.64781827398E+01 5.74436408228E+01 5.84256020644E+01 5.94243485629E+01 6.04401672390E+01 6.14733499176E+01 6.25241934122E+01 6.35929996098E+01 6.46800755577E+01 6.57857335518E+01 6.69102912262E+01 6.80540716446E+01 6.92174033930E+01 7.04006206740E+01 7.16040634032E+01 7.28280773063E+01 7.40730140188E+01 7.53392311870E+01 7.66270925705E+01 7.79369681470E+01 7.92692342184E+01 8.06242735189E+01 8.20024753252E+01 4.20127487571E-05 4.27308980635E-05 4.34613231301E-05 4.42042337938E-05 4.49598434784E-05 4.57283692561E-05 4.65100319094E-05 4.73050559949E-05 4.81136699076E-05 4.89361059465E-05 4.97726003818E-05 5.06233935220E-05 5.14887297836E-05 5.23688577609E-05 5.32640302976E-05 5.41745045595E-05 5.51005421083E-05 5.60424089766E-05 5.70003757445E-05 5.79747176173E-05 5.89657145047E-05 5.99736511008E-05 6.09988169663E-05 6.20415066116E-05 6.31020195812E-05 6.41806605399E-05 6.52777393604E-05 6.63935712123E-05 6.75284766524E-05 6.86827817171E-05 6.98568180159E-05 7.10509228268E-05 7.22654391929E-05 7.35007160212E-05 7.47571081830E-05 7.60349766154E-05 7.73346884252E-05 7.86566169945E-05 8.00011420877E-05 8.13686499611E-05 8.27595334729E-05 8.41741921973E-05 8.56130325383E-05 8.70764678468E-05 8.85649185396E-05 9.00788122196E-05 9.16185837993E-05 9.31846756252E-05 9.47775376052E-05 9.63976273378E-05 9.80454102433E-05 9.97213596979E-05 1.01425957169E-04 1.03159692356E-04 1.04923063326E-04 1.06716576661E-04 1.08540747604E-04 1.10396100203E-04 1.12283167466E-04 1.14202491510E-04 1.16154623720E-04 1.18140124905E-04 1.20159565463E-04 1.22213525538E-04 1.24302595194E-04 1.26427374580E-04 1.28588474105E-04 1.30786514610E-04 1.33022127550E-04 1.35295955173E-04 1.37608650706E-04 1.39960878541E-04 1.42353314428E-04 1.44786645668E-04 1.47261571310E-04 1.49778802351E-04 1.52339061944E-04 1.54943085602E-04 1.57591621409E-04 1.60285430240E-04 1.63025285974E-04 1.65811975717E-04 1.68646300033E-04 1.71529073167E-04 1.74461123284E-04 1.77443292706E-04 1.80476438153E-04 1.83561430988E-04 1.86699157470E-04 1.89890519007E-04 1.93136432415E-04 1.96437830184E-04 1.99795660739E-04 2.03210888722E-04 2.06684495261E-04 2.10217478256E-04 2.13810852664E-04 2.17465650793E-04 2.21182922595E-04 2.24963735971E-04 2.28809177075E-04 2.32720350628E-04 2.36698380234E-04 2.40744408705E-04 2.44859598386E-04 2.49045131491E-04 2.53302210443E-04 2.57632058218E-04 2.62035918699E-04 2.66515057028E-04 2.71070759976E-04 2.75704336308E-04 2.80417117160E-04 2.85210456424E-04 2.90085731133E-04 2.95044341859E-04 3.00087713115E-04 3.05217293765E-04 3.10434557436E-04 3.15741002949E-04 3.21138154742E-04 3.26627563312E-04 3.32210805661E-04 3.37889485746E-04 3.43665234942E-04 3.49539712509E-04 3.55514606072E-04 3.61591632102E-04 3.67772536411E-04 3.74059094652E-04 3.80453112834E-04 3.86956427832E-04 3.93570907924E-04 4.00298453322E-04 4.07140996720E-04 4.14100503847E-04 4.21178974036E-04 4.28378440794E-04 4.35700972389E-04 4.43148672442E-04 4.50723680533E-04 4.58428172815E-04 4.66264362641E-04 4.74234501195E-04 4.82340878145E-04 4.90585822296E-04 4.98971702260E-04 5.07500927138E-04 5.16175947212E-04 5.24999254648E-04 5.33973384210E-04 5.43100913992E-04 5.52384466158E-04 5.61826707692E-04 5.71430351167E-04 5.81198155524E-04 5.91132926865E-04 6.01237519256E-04 6.11514835553E-04 6.21967828228E-04 6.32599500225E-04 6.43412905817E-04 6.54411151486E-04 6.65597396816E-04 6.76974855398E-04 6.88546795755E-04 7.00316542283E-04 7.12287476203E-04 7.24463036530E-04 7.36846721069E-04 7.49442087413E-04 7.62252753965E-04 7.75282400984E-04 7.88534771634E-04 8.02013673066E-04 8.15722977506E-04 8.29666623372E-04 8.43848616404E-04 8.58273030815E-04 8.72944010460E-04 8.87865770026E-04 9.03042596247E-04 9.18478849131E-04 9.34178963216E-04 9.50147448839E-04 9.66388893438E-04 9.82907962866E-04 9.99709402732E-04 1.01679803976E-03 1.03417878320E-03 1.05185662618E-03 1.06983664722E-03 1.08812401163E-03 1.10672397300E-03 1.12564187476E-03 1.14488315165E-03 1.16445333131E-03 1.18435803589E-03 1.20460298360E-03 1.22519399045E-03 1.24613697182E-03 1.26743794423E-03 1.28910302703E-03 1.31113844419E-03 1.33355052605E-03 1.35634571117E-03 1.37953054817E-03 1.40311169759E-03 1.42709593386E-03 1.45149014718E-03 1.47630134553E-03 1.50153665668E-03 1.52720333026E-03 1.55330873981E-03 1.57986038490E-03 1.60686589330E-03 1.63433302318E-03 1.66226966532E-03 1.69068384536E-03 1.71958372615E-03 1.74897761008E-03 1.77887394143E-03 1.80928130883E-03 1.84020844775E-03 1.87166424295E-03 1.90365773106E-03 1.93619810320E-03 1.96929470759E-03 2.00295705224E-03 2.03719480770E-03 2.07201780980E-03 2.10743606252E-03 2.14345974084E-03 2.18009919367E-03 2.21736494681E-03 2.25526770599E-03 2.29381835994E-03 2.33302798352E-03 2.37290784089E-03 2.41346938877E-03 2.45472427970E-03 2.49668436542E-03 2.53936170024E-03 2.58276854454E-03 2.62691736826E-03 2.67182085451E-03 2.71749190319E-03 2.76394363470E-03 2.81118939374E-03 2.85924275309E-03 2.90811751756E-03 2.95782772791E-03 3.00838766494E-03 3.05981185352E-03 3.11211506684E-03 3.16531233060E-03 3.21941892734E-03 3.27445040084E-03 3.33042256057E-03 3.38735148626E-03 3.44525353249E-03 3.50414533338E-03 3.56404380742E-03 3.62496616228E-03 3.68692989978E-03 3.74995282088E-03 3.81405303087E-03 3.87924894449E-03 3.94555929126E-03 4.01300312087E-03 4.08159980862E-03 4.15136906101E-03 4.22233092140E-03 4.29450577576E-03 4.36791435853E-03 4.44257775857E-03 4.51851742523E-03 4.59575517451E-03 4.67431319532E-03 4.75421405586E-03 4.83548071010E-03 4.91813650437E-03 5.00220518410E-03 5.08771090057E-03 5.17467821794E-03 5.26313212023E-03 5.35309801852E-03 5.44460175829E-03 5.53766962679E-03 5.63232836061E-03 5.72860515339E-03 5.82652766356E-03 5.92612402239E-03 6.02742284198E-03 6.13045322351E-03 6.23524476562E-03 6.34182757289E-03 6.45023226451E-03 6.56048998304E-03 6.67263240339E-03 6.78669174191E-03 6.90270076564E-03 7.02069280173E-03 7.14070174700E-03 7.26276207770E-03 7.38690885941E-03 7.51317775709E-03 7.64160504536E-03 7.77222761888E-03 7.90508300300E-03 8.04020936450E-03 8.17764552256E-03 8.31743095993E-03 8.45960583427E-03 8.60421098967E-03 8.75128796838E-03 8.90087902279E-03 9.05302712749E-03 9.20777599171E-03 9.36517007179E-03 9.52525458401E-03 9.68807551755E-03 9.85367964771E-03 1.00221145494E-02 1.01934286106E-02 1.03676710466E-02 1.05448919139E-02 1.07251421245E-02 1.09084734610E-02 1.10949385908E-02 1.12845910818E-02 1.14774854174E-02 1.16736770125E-02 1.18732222291E-02 1.20761783926E-02 1.22826038086E-02 1.24925577789E-02 1.27061006194E-02 1.29232936766E-02 1.31441993461E-02 1.33688810897E-02 1.35974034542E-02 1.38298320895E-02 1.40662337680E-02 1.43066764032E-02 1.45512290697E-02 1.47999620228E-02 1.50529467185E-02 1.53102558346E-02 1.55719632909E-02 1.58381442709E-02 1.61088752433E-02 1.63842339838E-02 1.66642995977E-02 1.69491525424E-02 1.72388746506E-02 1.75335491540E-02 1.78332607067E-02 1.81380954101E-02 1.84481408374E-02 1.87634860585E-02 1.90842216661E-02 1.94104398013E-02 1.97422341802E-02 2.00797001210E-02 2.04229345711E-02 2.07720361351E-02 2.11271051031E-02 2.14882434795E-02 2.18555550125E-02 2.22291452235E-02 2.26091214378E-02 2.29955928152E-02 2.33886703814E-02 2.37884670601E-02 2.41950977050E-02 2.46086791332E-02 2.50293301588E-02 2.54571716266E-02 2.58923264472E-02 2.63349196321E-02 2.67850783298E-02 2.72429318623E-02 2.77086117618E-02 2.81822518094E-02 2.86639880725E-02 2.91539589448E-02 2.96523051853E-02 3.01591699593E-02 3.06746988792E-02 3.11990400465E-02 3.17323440943E-02 3.22747642305E-02 3.28264562819E-02 3.33875787390E-02 3.39582928014E-02 3.45387624242E-02 3.51291543651E-02 3.57296382322E-02 3.63403865330E-02 3.69615747237E-02 3.75933812595E-02 3.82359876463E-02 3.88895784924E-02 3.95543415619E-02 4.02304678284E-02 4.09181515297E-02 4.16175902242E-02 4.23289848470E-02 4.30525397680E-02 4.37884628507E-02 4.45369655113E-02 4.52982627804E-02 4.60725733637E-02 4.68601197059E-02 4.76611280536E-02 4.84758285212E-02 4.93044551562E-02 5.01472460071E-02 5.10044431915E-02 5.18762929653E-02 5.27630457943E-02 5.36649564253E-02 5.45822839599E-02 5.55152919284E-02 5.64642483660E-02 5.74294258896E-02 5.84111017759E-02 5.94095580414E-02 6.04250815233E-02 6.14579639619E-02 6.25085020843E-02 6.35769976897E-02 6.46637577363E-02 6.57690944292E-02 6.68933253102E-02 6.80367733491E-02 6.91997670365E-02 7.03826404779E-02 7.15857334899E-02 7.28093916978E-02 7.40539666351E-02 7.53198158441E-02 7.66073029785E-02 7.79167979088E-02 7.92486768273E-02 8.06033223571E-02 8.19811236617E-02 8.33824765568E-02 8.48077836238E-02 8.62574543259E-02 8.77319051256E-02 8.92315596038E-02 9.07568485825E-02 9.23082102475E-02 9.38860902751E-02 9.54909419597E-02 9.71232263440E-02 9.87834123519E-02 1.00471976923E-01 1.02189405148E-01 1.03936190412E-01 1.05712834532E-01 1.07519847904E-01 1.09357749648E-01 1.11227067757E-01 1.13128339251E-01 1.15062110327E-01 1.17028936520E-01 1.19029382863E-01 1.21064024044E-01 1.23133444577E-01 1.25238238965E-01 1.27379011876E-01 1.29556378312E-01 1.31770963789E-01 1.34023404513E-01 1.36314347568E-01 1.38644451098E-01 1.41014384495E-01 1.43424828597E-01 1.45876475876E-01 1.48370030644E-01 1.50906209251E-01 1.53485740291E-01 1.56109364814E-01 1.58777836538E-01 1.61491922061E-01 1.64252401088E-01 1.67060066652E-01 1.69915725340E-01 1.72820197528E-01 1.75774317614E-01 1.78778934261E-01 1.81834910636E-01 1.84943124662E-01 1.88104469269E-01 1.91319852650E-01 1.94590198522E-01 1.97916446393E-01 2.01299551830E-01 2.04740486732E-01 2.08240239614E-01 2.11799815887E-01 2.15420238149E-01 2.19102546477E-01 2.22847798726E-01 2.26657070836E-01 2.30531457136E-01 2.34472070663E-01 2.38480043479E-01 2.42556526996E-01 2.46702692310E-01 2.50919730533E-01 2.55208853140E-01 2.59571292311E-01 2.64008301292E-01 2.68521154749E-01 2.73111149138E-01 2.77779603075E-01 2.82527857716E-01 2.87357277144E-01 2.92269248757E-01 2.97265183670E-01 3.02346517118E-01 3.07514708869E-01 3.12771243645E-01 3.18117631548E-01 3.23555408490E-01 3.29086136639E-01 3.34711404868E-01 3.40432829207E-01 3.46252053309E-01 3.52170748926E-01 3.58190616385E-01 3.64313385076E-01 3.70540813954E-01 3.76874692036E-01 3.83316838925E-01 3.89869105325E-01 3.96533373574E-01 4.03311558187E-01 4.10205606408E-01 4.17217498761E-01 4.24349249627E-01 4.31602907822E-01 4.38980557181E-01 4.46484317158E-01 4.54116343441E-01 4.61878828561E-01 4.69774002531E-01 4.77804133481E-01 4.85971528313E-01 4.94278533361E-01 5.02727535067E-01 5.11320960666E-01 5.20061278882E-01 5.28951000640E-01 5.37992679784E-01 5.47188913815E-01 5.56542344633E-01 5.66055659296E-01 5.75731590797E-01 5.85572918843E-01 5.95582470657E-01 6.05763121790E-01 6.16117796946E-01 6.26649470822E-01 6.37361168965E-01 6.48255968639E-01 6.59336999708E-01 6.70607445538E-01 6.82070543911E-01 6.93729587952E-01 7.05587927080E-01 7.17648967965E-01 7.29916175512E-01 7.42393073851E-01 7.55083247355E-01 7.67990341664E-01 7.81118064737E-01 7.94470187915E-01 8.08050547004E-01 8.21863043379E-01 8.35911645102E-01 8.50200388065E-01 8.64733377148E-01 8.79514787397E-01 8.94548865225E-01 9.09839929631E-01 9.25392373443E-01 9.41210664577E-01 9.57299347322E-01 9.73663043644E-01 9.90306454518E-01 1.00723436127E+00 1.02445162697E+00 1.04196319779E+00 1.05977410448E+00 1.07788946376E+00 1.09631447983E+00 1.11505444583E+00 1.13411474540E+00 1.15350085418E+00 1.17321834144E+00 1.19327287163E+00 1.21367020602E+00 1.23441620438E+00 1.25551682663E+00 1.27697813456E+00 1.29880629360E+00 1.32100757456E+00 1.34358835543E+00 1.36655512324E+00 1.38991447589E+00 -6.18459697457E+00 -6.18459697457E+00 -6.18459689438E+00 -6.18459675627E+00 -6.18459655924E+00 -6.18459629887E+00 -6.18459597275E+00 -6.18459557738E+00 -6.18459510944E+00 -6.18459456536E+00 -6.18459394153E+00 -6.18459323411E+00 -6.18459243920E+00 -6.18459155266E+00 -6.18459057027E+00 -6.18458948758E+00 -6.18458830003E+00 -6.18458700281E+00 -6.18458559100E+00 -6.18458405942E+00 -6.18458240276E+00 -6.18458061543E+00 -6.18457869172E+00 -6.18457662560E+00 -6.18457441090E+00 -6.18457204114E+00 -6.18456950966E+00 -6.18456680949E+00 -6.18456393345E+00 -6.18456087403E+00 -6.18455762350E+00 -6.18455417378E+00 -6.18455051654E+00 -6.18454664307E+00 -6.18454254443E+00 -6.18453821125E+00 -6.18453363387E+00 -6.18452880223E+00 -6.18452370595E+00 -6.18451833419E+00 -6.18451267580E+00 -6.18450671909E+00 -6.18450045210E+00 -6.18449386225E+00 -6.18448693667E+00 -6.18447966186E+00 -6.18447202395E+00 -6.18446400845E+00 -6.18445560045E+00 -6.18444678437E+00 -6.18443754419E+00 -6.18442786317E+00 -6.18441772408E+00 -6.18440710896E+00 -6.18439599930E+00 -6.18438437577E+00 -6.18437221851E+00 -6.18435950677E+00 -6.18434621921E+00 -6.18433233354E+00 -6.18431782683E+00 -6.18430267518E+00 -6.18428685395E+00 -6.18427033747E+00 -6.18425309930E+00 -6.18423511188E+00 -6.18421634683E+00 -6.18419677456E+00 -6.18417636461E+00 -6.18415508523E+00 -6.18413290373E+00 -6.18410978603E+00 -6.18408569705E+00 -6.18406060022E+00 -6.18403445791E+00 -6.18400723088E+00 -6.18397887875E+00 -6.18394935943E+00 -6.18391862961E+00 -6.18388664414E+00 -6.18385335654E+00 -6.18381871840E+00 -6.18378267987E+00 -6.18374518903E+00 -6.18370619242E+00 -6.18366563435E+00 -6.18362345751E+00 -6.18357960217E+00 -6.18353400688E+00 -6.18348660761E+00 -6.18343733846E+00 -6.18338613080E+00 -6.18333291396E+00 -6.18327761439E+00 -6.18322015632E+00 -6.18316046091E+00 -6.18309844695E+00 -6.18303402993E+00 -6.18296712281E+00 -6.18289763502E+00 -6.18282547327E+00 -6.18275054049E+00 -6.18267273674E+00 -6.18259195798E+00 -6.18250809710E+00 -6.18242104265E+00 -6.18233067987E+00 -6.18223688933E+00 -6.18213954806E+00 -6.18203852815E+00 -6.18193369785E+00 -6.18182492011E+00 -6.18171205382E+00 -6.18159495217E+00 -6.18147346401E+00 -6.18134743209E+00 -6.18121669452E+00 -6.18108108289E+00 -6.18094042380E+00 -6.18079453691E+00 -6.18064323653E+00 -6.18048632953E+00 -6.18032361707E+00 -6.18015489236E+00 -6.17997994250E+00 -6.17979854608E+00 -6.17961047516E+00 -6.17941549270E+00 -6.17921335469E+00 -6.17900380736E+00 -6.17878658952E+00 -6.17856142954E+00 -6.17832804783E+00 -6.17808615368E+00 -6.17783544786E+00 -6.17757561923E+00 -6.17730634757E+00 -6.17702729995E+00 -6.17673813369E+00 -6.17643849256E+00 -6.17612800991E+00 -6.17580630462E+00 -6.17547298444E+00 -6.17512764166E+00 -6.17476985667E+00 -6.17439919336E+00 -6.17401520295E+00 -6.17361741899E+00 -6.17320536152E+00 -6.17277853176E+00 -6.17233641646E+00 -6.17187848229E+00 -6.17140418052E+00 -6.17091294097E+00 -6.17040417704E+00 -6.16987727924E+00 -6.16933162058E+00 -6.16876654969E+00 -6.16818139650E+00 -6.16757546497E+00 -6.16694803914E+00 -6.16629837538E+00 -6.16562570884E+00 -6.16492924516E+00 -6.16420816747E+00 -6.16346162741E+00 -6.16268875267E+00 -6.16188863745E+00 -6.16106035046E+00 -6.16020292480E+00 -6.15931536646E+00 -6.15839664355E+00 -6.15744569543E+00 -6.15646142114E+00 -6.15544268924E+00 -6.15438832547E+00 -6.15329712321E+00 -6.15216783039E+00 -6.15099916066E+00 -6.14978977946E+00 -6.14853831592E+00 -6.14724334805E+00 -6.14590341549E+00 -6.14451700371E+00 -6.14308255766E+00 -6.14159846492E+00 -6.14006307038E+00 -6.13847465822E+00 -6.13683146766E+00 -6.13513167380E+00 -6.13337340443E+00 -6.13155471970E+00 -6.12967363010E+00 -6.12772807481E+00 -6.12571594095E+00 -6.12363504067E+00 -6.12148313163E+00 -6.11925789270E+00 -6.11695694594E+00 -6.11457783076E+00 -6.11211802744E+00 -6.10957492975E+00 -6.10694587012E+00 -6.10422809059E+00 -6.10141876982E+00 -6.09851499220E+00 -6.09551377689E+00 -6.09241204504E+00 -6.08920665094E+00 -6.08589434727E+00 -6.08247181848E+00 -6.07893564409E+00 -6.07528233441E+00 -6.07150829170E+00 -6.06760984855E+00 -6.06358322678E+00 -6.05942457855E+00 -6.05512994304E+00 -6.05069529047E+00 -6.04611647635E+00 -6.04138928874E+00 -6.03650939999E+00 -6.03147241732E+00 -6.02627383203E+00 -6.02090907369E+00 -6.01537345662E+00 -6.00966223797E+00 -6.00377056132E+00 -5.99769351891E+00 -5.99142609231E+00 -5.98496321894E+00 -5.97829972972E+00 -5.97143042014E+00 -5.96434998469E+00 -5.95705309274E+00 -5.94953431962E+00 -5.94178822747E+00 -5.93380929280E+00 -5.92559199245E+00 -5.91713072746E+00 -5.90841991429E+00 -5.89945390467E+00 -5.89022708222E+00 -5.88073377791E+00 -5.87096837216E+00 -5.86092520554E+00 -5.85059868615E+00 -5.83998319523E+00 -5.82907319967E+00 -5.81786315185E+00 -5.80634760705E+00 -5.79452111692E+00 -5.78237835129E+00 -5.76991398452E+00 -5.75712282117E+00 -5.74399967425E+00 -5.73053949407E+00 -5.71673723738E+00 -5.70258799844E+00 -5.68808686793E+00 -5.67322906517E+00 -5.65800978559E+00 -5.64242433277E+00 -5.62646795326E+00 -5.61013596708E+00 -5.59342358848E+00 -5.57632605353E+00 -5.55883842547E+00 -5.54095571801E+00 -5.52267268408E+00 -5.50398393343E+00 -5.48488370384E+00 -5.46536597183E+00 -5.44542420577E+00 -5.42505146874E+00 -5.40424015343E+00 -5.38298207682E+00 -5.36126819722E+00 -5.33908870102E+00 -5.31643270321E+00 -5.29328832710E+00 -5.26964239063E+00 -5.24548048104E+00 -5.22078663036E+00 -5.19554338824E+00 -5.16973149154E+00 -5.14332994016E+00 -5.11631566733E+00 -5.08866362541E+00 -5.06034646616E+00 -5.03133464631E+00 -5.00159613061E+00 -4.97109653136E+00 -4.93979885220E+00 -4.90766368217E+00 -4.87464900585E+00 -4.84071048161E+00 -4.80580135475E+00 -4.76987286212E+00 -4.73287429943E+00 -4.69475361083E+00 -4.65545767937E+00 -4.61493317899E+00 -4.57312717681E+00 -4.52998834356E+00 -4.48546797444E+00 -4.43952166788E+00 -4.39211088153E+00 -4.34320519046E+00 -4.29278448533E+00 -4.24084189252E+00 -4.18738666788E+00 -4.13244776487E+00 -4.07607732289E+00 -4.01835462683E+00 -3.95938973179E+00 -3.89932705076E+00 -3.83834798520E+00 -3.77667254399E+00 -3.71455891586E+00 -3.65230062450E+00 -3.59022034930E+00 -3.52866009172E+00 -3.46796749168E+00 -3.40847871435E+00 -3.35049908195E+00 -3.29428288075E+00 -3.24001433608E+00 -3.18779049337E+00 -3.13760566936E+00 -3.08933361041E+00 -3.04270130556E+00 -2.99724667327E+00 -2.95225761341E+00 -2.90670484347E+00 -2.85921095599E+00 -2.80813999812E+00 -2.75192987244E+00 -2.68979022418E+00 -2.62293345536E+00 -2.55709907763E+00 -2.50170071280E+00 -2.45773864384E+00 -2.41709457399E+00 -2.37639929420E+00 -2.33632845426E+00 -2.29695225642E+00 -2.25824088813E+00 -2.22018372800E+00 -2.18276965899E+00 -2.14598775632E+00 -2.10982728272E+00 -2.07427768515E+00 -2.03932859159E+00 -2.00496980787E+00 -1.97119131457E+00 -1.93798326395E+00 -1.90533597697E+00 -1.87323994033E+00 -1.84168580361E+00 -1.81066437640E+00 -1.78016662555E+00 -1.75018367238E+00 -1.72070679006E+00 -1.69172740091E+00 -1.66323707386E+00 -1.63522752187E+00 -1.60769059944E+00 -1.58061830015E+00 -1.55400275428E+00 -1.52783622638E+00 -1.50211111302E+00 -1.47681994045E+00 -1.45195536237E+00 -1.42751015773E+00 -1.40347722857E+00 -1.37984959789E+00 -1.35662040756E+00 -1.33378291625E+00 -1.31133049746E+00 -1.28925663749E+00 -1.26755493352E+00 -1.24621909172E+00 -1.22524292532E+00 -1.20462035281E+00 -1.18434539612E+00 -1.16441217882E+00 -1.14481492440E+00 -1.12554795453E+00 -1.10660568741E+00 -1.08798263604E+00 -1.06967340667E+00 -1.05167269715E+00 -1.03397529538E+00 -1.01657607777E+00 -9.99470007693E-01 -9.82652134017E-01 -9.66117589641E-01 -9.49861590049E-01 -9.33879431895E-01 -9.18166491616E-01 -9.02718224065E-01 -8.87530161170E-01 -8.72597910616E-01 -8.57917154549E-01 -8.43483648303E-01 -8.29293219148E-01 -8.15341765065E-01 -8.01625253533E-01 -7.88139720346E-01 -7.74881268445E-01 -7.61846066772E-01 -7.49030349145E-01 -7.36430413152E-01 -7.24042619059E-01 -7.11863388746E-01 -6.99889204655E-01 -6.88116608760E-01 -6.76542201547E-01 -6.65162641025E-01 -6.53974641740E-01 -6.42974973816E-01 -6.32160462008E-01 -6.21527984772E-01 -6.11074473352E-01 -6.00796910879E-01 -5.90692331494E-01 -5.80757819476E-01 -5.70990508390E-01 -5.61387580252E-01 -5.51946264704E-01 -5.42663838202E-01 -5.33537623225E-01 -5.24564987491E-01 -5.15743343189E-01 -5.07070146223E-01 -4.98542895472E-01 -4.90159132058E-01 -4.81916438629E-01 -4.73812438658E-01 -4.65844795746E-01 -4.58011212942E-01 -4.50309432078E-01 -4.42737233104E-01 -4.35292433449E-01 -4.27972887380E-01 -4.20776485381E-01 -4.13701153538E-01 -4.06744852936E-01 -3.99905579064E-01 -3.93181361236E-01 -3.86570262013E-01 -3.80070376647E-01 -3.73679832519E-01 -3.67396788601E-01 -3.61219434921E-01 -3.55145992032E-01 -3.49174710501E-01 -3.43303870400E-01 -3.37531780804E-01 -3.31856779303E-01 -3.26277231518E-01 -3.20791530628E-01 -3.15398096903E-01 -3.10095377246E-01 -3.04881844743E-01 -2.99755998220E-01 -2.94716361807E-01 -2.89761484513E-01 -2.84889939802E-01 -2.80100325180E-01 -2.75391261792E-01 -2.70761394019E-01 -2.66209389088E-01 -2.61733936683E-01 -2.57333748567E-01 -2.53007558212E-01 -2.48754120426E-01 -2.44572210998E-01 -2.40460626343E-01 -2.36418183150E-01 -2.32443718043E-01 -2.28536087244E-01 -2.24694166242E-01 -2.20916849465E-01 -2.17203049967E-01 -2.13551699104E-01 -2.09961746234E-01 -2.06432158409E-01 -2.02961920075E-01 -1.99550032782E-01 -1.96195514895E-01 -1.92897401305E-01 -1.89654743159E-01 -1.86466607577E-01 -1.83332077389E-01 -1.80250250866E-01 -1.77220241463E-01 -1.74241177558E-01 -1.71312202206E-01 -1.68432472888E-01 -1.65601161268E-01 -1.62817452955E-01 -1.60080547265E-01 -1.57389656997E-01 -1.54744008518E-01 -1.52142840222E-01 -1.49585404351E-01 -1.47070965377E-01 -1.44598800155E-01 -1.42168197709E-01 -1.39778459029E-01 -1.37428896869E-01 -1.35118835550E-01 -1.32847610763E-01 -1.30614569379E-01 -1.28419069260E-01 -1.26260479074E-01 -1.24138178112E-01 -1.22051556110E-01 -1.20000013073E-01 -1.17982959102E-01 -1.15999814224E-01 -1.14050008224E-01 -1.12132980481E-01 -1.10248179806E-01 -1.08395064286E-01 -1.06573101123E-01 -1.04781766483E-01 -1.03020545347E-01 -1.01288931359E-01 -9.95864266809E-02 -9.79125418518E-02 -9.62667956433E-02 -9.46487149229E-02 -9.30578345174E-02 -9.14936970785E-02 -8.99558529515E-02 -8.84438600453E-02 -8.69572837054E-02 -8.54956965887E-02 -8.40586785402E-02 -8.26458164713E-02 -8.12567042441E-02 -7.98909425493E-02 -7.85481387950E-02 -7.72279069924E-02 -7.59298676445E-02 -7.46536476376E-02 -7.33988801329E-02 -7.21652044615E-02 -7.09522660206E-02 -6.97597161707E-02 -6.85872121363E-02 -6.74344169063E-02 -6.63009991373E-02 -6.51866330585E-02 -6.40909983775E-02 -6.30137801883E-02 -6.19546688808E-02 -6.09133600513E-02 -5.98895544154E-02 -5.88829577212E-02 -5.78932806654E-02 -5.69202388093E-02 -5.59635524976E-02 -5.50229467775E-02 -5.40981513194E-02 -5.31889003400E-02 -5.22949325246E-02 -5.14159909528E-02 -5.05518230245E-02 -4.97021803868E-02 -4.88668188627E-02 -4.80454983810E-02 -4.72379829074E-02 -4.64440403760E-02 -4.56634426230E-02 -4.48959653209E-02 -4.41413879142E-02 -4.33994935557E-02 -4.26700690439E-02 -4.19529047623E-02 -4.12477946187E-02 -4.05545359859E-02 -3.98729296434E-02 -3.92027797205E-02 -3.85438936394E-02 -3.78960820601E-02 -3.72591588261E-02 -3.66329409104E-02 -3.60172483634E-02 -3.54119042607E-02 -3.48167346525E-02 -3.42315685133E-02 -3.36562376933E-02 -3.30905768691E-02 -3.25344234970E-02 -3.19876177660E-02 -3.14500025517E-02 -3.09214233712E-02 -3.04017283387E-02 -2.98907681217E-02 -2.93883958986E-02 -2.88944673155E-02 -2.84088404456E-02 -2.79313757480E-02 -2.74619360276E-02 -2.70003863957E-02 -2.65465942311E-02 -2.61004291421E-02 -2.56617629291E-02 -2.52304695475E-02 -2.48064250716E-02 -2.43895076590E-02 1 0 Beta L 371 0.00000000000E+00 1.10708955834E-04 2.23311072103E-04 3.37834923263E-04 4.54319718895E-04 5.72794132268E-04 6.93294333311E-04 8.15850358146E-04 9.40506665233E-04 1.06728829126E-03 1.19623816937E-03 1.32739339957E-03 1.46078727081E-03 1.59646071952E-03 1.73445252161E-03 1.87480335566E-03 2.01754928997E-03 2.16273667061E-03 2.31040172910E-03 2.46059070456E-03 2.61334364814E-03 2.76870688312E-03 2.92672261271E-03 3.08743730967E-03 3.25089556288E-03 3.41714541911E-03 3.58623366304E-03 3.75820815438E-03 3.93311863688E-03 4.11101563050E-03 4.29194623174E-03 4.47596752833E-03 4.66312804254E-03 4.85347950604E-03 5.04708325911E-03 5.24398543402E-03 5.44424721455E-03 5.64792617079E-03 5.85507522910E-03 6.06576030278E-03 6.28003236897E-03 6.49796111092E-03 6.71960134244E-03 6.94501798141E-03 7.17427935549E-03 7.40743965529E-03 7.64457684142E-03 7.88574972675E-03 8.13102764774E-03 8.38048371295E-03 8.63418103030E-03 8.89220040553E-03 9.15460316089E-03 9.42147436186E-03 9.69287916734E-03 9.96889863692E-03 1.02496112016E-02 1.05350895368E-02 1.08254207981E-02 1.11206795706E-02 1.14209511501E-02 1.17263179296E-02 1.20368678332E-02 1.23526811311E-02 1.26738504759E-02 1.30004626189E-02 1.33326067620E-02 1.36703774458E-02 1.40138643392E-02 1.43631637643E-02 1.47183703191E-02 1.50795827971E-02 1.54468972667E-02 1.58204175999E-02 1.62002407836E-02 1.65864746086E-02 1.69792178450E-02 1.73785845223E-02 1.77846737646E-02 1.81976006638E-02 1.86174733073E-02 1.90444031514E-02 1.94785069146E-02 1.99198985937E-02 2.03686914812E-02 2.08250101201E-02 2.12889695042E-02 2.17606944488E-02 2.22403066422E-02 2.27279305074E-02 2.32236936165E-02 2.37277216263E-02 2.42401472701E-02 2.47610985332E-02 2.52907105346E-02 2.58291141635E-02 2.63764485921E-02 2.69328477719E-02 2.74984540470E-02 2.80734024917E-02 2.86578398339E-02 2.92519065093E-02 2.98557464082E-02 3.04695060276E-02 3.10933338899E-02 3.17273756109E-02 3.23717838718E-02 3.30267066671E-02 3.36922978215E-02 3.43687106235E-02 3.50560972215E-02 3.57546161006E-02 3.64644197742E-02 3.71856671664E-02 3.79185156915E-02 3.86631224745E-02 3.94196487238E-02 4.01882502271E-02 4.09690899947E-02 4.17623252224E-02 4.25681175265E-02 4.33866253620E-02 4.42180106513E-02 4.50624290255E-02 4.59200437154E-02 4.67910083222E-02 4.76754836298E-02 4.85736239175E-02 4.94855838532E-02 5.04115178281E-02 5.13515762804E-02 5.23059090706E-02 5.32746625533E-02 5.42579832674E-02 5.52560101574E-02 5.62688827755E-02 5.72967360133E-02 5.83397001766E-02 5.93979014100E-02 6.04714620213E-02 6.15604975869E-02 6.26651186071E-02 6.37854302510E-02 6.49215304337E-02 6.60735079332E-02 6.72414476751E-02 6.84254218101E-02 6.96254967892E-02 7.08417274791E-02 7.20741580865E-02 7.33228233018E-02 7.45877437097E-02 7.58689267999E-02 7.71663706499E-02 7.84800507580E-02 7.98099349695E-02 8.11559679105E-02 8.25180812117E-02 8.38961834734E-02 8.52901659906E-02 8.66998968583E-02 8.81252216549E-02 8.95659612014E-02 9.10219128615E-02 9.24928416804E-02 9.39784894434E-02 9.54785625802E-02 9.69927381304E-02 9.85206557190E-02 1.00061921717E-01 1.01616100988E-01 1.03182719355E-01 1.04761258134E-01 1.06351156224E-01 1.07951799242E-01 1.09562527294E-01 1.11182623812E-01 1.12811317105E-01 1.14447775331E-01 1.16091104756E-01 1.17740345442E-01 1.19394467305E-01 1.21052368075E-01 1.22712868863E-01 1.24374708223E-01 1.26036541592E-01 1.27696934493E-01 1.29354358287E-01 1.31007186249E-01 1.32653688477E-01 1.34292026406E-01 1.35920247431E-01 1.37536281547E-01 1.39137930921E-01 1.40722870214E-01 1.42288635048E-01 1.43832618522E-01 1.45352064770E-01 1.46844059890E-01 1.48305527827E-01 1.49733220824E-01 1.51123713648E-01 1.52473394542E-01 1.53778458171E-01 1.55034897143E-01 1.56238494166E-01 1.57384812535E-01 1.58469188543E-01 1.59486722008E-01 1.60432266608E-01 1.61300422459E-01 1.62085524271E-01 1.62781634912E-01 1.63382532475E-01 1.63881703661E-01 1.64272332783E-01 1.64547292201E-01 1.64699133271E-01 1.64720077158E-01 1.64602004432E-01 1.64336448565E-01 1.63914584098E-01 1.63327222269E-01 1.62564799237E-01 1.61617372735E-01 1.60474612992E-01 1.59125798629E-01 1.57559811370E-01 1.55765133065E-01 1.53729842535E-01 1.51441616200E-01 1.48887727054E-01 1.46055049785E-01 1.42930062288E-01 1.39498856591E-01 1.35747144796E-01 1.31660274889E-01 1.27223244117E-01 1.22420720033E-01 1.17237063081E-01 1.11656354246E-01 1.05662428353E-01 9.92389110365E-02 9.23692626450E-02 8.50368287139E-02 7.72248958744E-02 6.89167565051E-02 6.00957832382E-02 5.07455066878E-02 4.08497105938E-02 3.03925313413E-02 1.93585715565E-02 7.73302585206E-03 -4.49818183856E-03 -1.73482443930E-02 -3.08293045997E-02 -4.49522711724E-02 -5.97266172811E-02 -7.51601609190E-02 -9.12588260975E-02 -1.08026382081E-01 -1.25464162300E-01 -1.43570759003E-01 -1.62341693864E-01 -1.81769064025E-01 -2.01841160449E-01 -2.22542059801E-01 -2.43851188575E-01 -2.65742856198E-01 -2.88185761124E-01 -3.11142465127E-01 -3.34568838960E-01 -3.58413477373E-01 -3.82617086084E-01 -4.07111839840E-01 -4.31820715606E-01 -4.56656800678E-01 -4.81522580709E-01 -5.06309211152E-01 -5.30895776272E-01 -5.55148542903E-01 -5.78920216079E-01 -6.02049205069E-01 -6.24358911416E-01 -6.45657050119E-01 -6.65735021238E-01 -6.84367345118E-01 -7.01311187020E-01 -7.16305987057E-01 -7.29073228230E-01 -7.39316368124E-01 -7.46720970324E-01 -7.50955073105E-01 -7.51669838468E-01 -7.48500530085E-01 -7.41067872446E-01 -7.28979851601E-01 -7.11834021024E-01 -6.89220384714E-01 -6.60724933072E-01 -6.25933915379E-01 -5.84438936080E-01 -5.35842968546E-01 -4.79767382657E-01 -4.15860086092E-01 -3.43804878681E-01 -2.63332117690E-01 -1.74230786903E-01 -7.63620498712E-02 3.03256449056E-02 1.45779865687E-01 2.69825895445E-01 4.02146861036E-01 5.42262386945E-01 6.89505943687E-01 8.43001159888E-01 1.00163749269E+00 1.16404580984E+00 1.32857463452E+00 1.49326805234E+00 1.65584658336E+00 1.81369270018E+00 1.96384313160E+00 2.10299065643E+00 2.22749877501E+00 2.33343347862E+00 2.41661734089E+00 2.47271237141E+00 2.49733953114E+00 2.48624456854E+00 2.43552194255E+00 2.34191112413E+00 2.20318258931E+00 2.01863442423E+00 1.78972476970E+00 1.52087046786E+00 1.22044836181E+00 9.02043249580E-01 5.85992563134E-01 3.01313196721E-01 8.78665449565E-02 9.64289963405E-04 -9.41616229595E-05 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1 Number of nonzero Dij 1 1 -4.63365067404E-01 8 nqf. If not zero, Qij's inside rinner are computed using qfcoef's 1 8.00000000000E-01 1 1 0 i j (l(j)) 2.69417219665E-01 Q_int 0.00000000000E+00 1.98808187842E-08 8.08884214134E-08 1.85132115685E-07 3.34805748427E-07 5.32190821646E-07 7.79659719510E-07 1.07967905003E-06 1.43481310548E-06 1.84772744559E-06 2.32119260805E-06 2.85808795043E-06 3.46140562840E-06 4.13425471484E-06 4.87986546482E-06 5.70159373149E-06 6.60292553823E-06 7.58748181237E-06 8.65902328623E-06 9.82145557126E-06 1.10788344113E-05 1.24353711212E-05 1.38954382172E-05 1.54635752460E-05 1.71444948189E-05 1.89430888589E-05 2.08644350670E-05 2.29138036170E-05 2.50966640849E-05 2.74186926225E-05 2.98857793830E-05 3.25040362069E-05 3.52798045785E-05 3.82196638614E-05 4.13304398228E-05 4.46192134567E-05 4.80933301164E-05 5.17604089676E-05 5.56283527714E-05 5.97053580110E-05 6.39999253719E-05 6.85208705896E-05 7.32773356754E-05 7.82788005361E-05 8.35350949985E-05 8.90564112543E-05 9.48533167396E-05 1.00936767464E-04 1.07318121804E-04 1.14009154777E-04 1.21022072818E-04 1.28369529060E-04 1.36064639159E-04 1.44120997663E-04 1.52552694950E-04 1.61374334762E-04 1.70601052338E-04 1.80248533189E-04 1.90333032517E-04 2.00871395310E-04 2.11881077139E-04 2.23380165672E-04 2.35387402933E-04 2.47922208341E-04 2.61004702539E-04 2.74655732047E-04 2.88896894784E-04 3.03750566451E-04 3.19239927846E-04 3.35388993110E-04 3.52222638960E-04 3.69766634925E-04 3.88047674624E-04 4.07093408133E-04 4.26932475460E-04 4.47594541177E-04 4.69110330245E-04 4.91511665074E-04 5.14831503857E-04 5.39103980225E-04 5.64364444259E-04 5.90649504925E-04 6.17997073949E-04 6.46446411211E-04 6.76038171690E-04 7.06814454022E-04 7.38818850713E-04 7.72096500085E-04 8.06694139984E-04 8.42660163334E-04 8.80044675585E-04 9.18899554124E-04 9.59278509707E-04 1.00123714999E-03 1.04483304523E-03 1.09012579619E-03 1.13717710442E-03 1.18605084481E-03 1.23681314075E-03 1.28953244172E-03 1.34427960358E-03 1.40112797149E-03 1.46015346578E-03 1.52143467053E-03 1.58505292534E-03 1.65109241998E-03 1.71964029244E-03 1.79078673007E-03 1.86462507430E-03 1.94125192870E-03 2.02076727080E-03 2.10327456757E-03 2.18888089475E-03 2.27769706020E-03 2.36983773133E-03 2.46542156675E-03 2.56457135232E-03 2.66741414167E-03 2.77408140140E-03 2.88470916102E-03 2.99943816786E-03 3.11841404710E-03 3.24178746696E-03 3.36971430936E-03 3.50235584618E-03 3.63987892112E-03 3.78245613765E-03 3.93026605292E-03 4.08349337797E-03 4.24232918442E-03 4.40697111776E-03 4.57762361751E-03 4.75449814438E-03 4.93781341467E-03 5.12779564212E-03 5.32467878740E-03 5.52870481542E-03 5.74012396081E-03 5.95919500155E-03 6.18618554126E-03 6.42137230014E-03 6.66504141492E-03 6.91748874799E-03 7.17902020601E-03 7.44995206816E-03 7.73061132431E-03 8.02133602337E-03 8.32247563199E-03 8.63439140394E-03 8.95745676036E-03 9.29205768112E-03 9.63859310754E-03 9.99747535671E-03 1.03691305477E-02 1.07539990397E-02 1.11525358825E-02 1.15652112799E-02 1.19925110649E-02 1.24349371888E-02 1.28930082229E-02 1.33672598738E-02 1.38582455118E-02 1.43665367133E-02 1.48927238174E-02 1.54374164951E-02 1.60012443339E-02 1.65848574362E-02 1.71889270312E-02 1.78141461016E-02 1.84612300248E-02 1.91309172272E-02 1.98239698539E-02 2.05411744512E-02 2.12833426639E-02 2.20513119452E-02 2.28459462811E-02 2.36681369266E-02 2.45188031554E-02 2.53988930212E-02 2.63093841307E-02 2.72512844279E-02 2.82256329879E-02 2.92335008204E-02 3.02759916821E-02 3.13542428954E-02 3.24694261742E-02 3.36227484540E-02 3.48154527252E-02 3.60488188684E-02 3.73241644892E-02 3.86428457510E-02 4.00062582027E-02 4.14158376002E-02 4.28730607174E-02 4.43794461450E-02 4.59365550732E-02 4.75459920544E-02 4.92094057434E-02 5.09284896083E-02 5.27049826106E-02 5.45406698468E-02 5.64373831474E-02 5.83970016270E-02 6.04214521788E-02 6.25127099070E-02 6.46727984893E-02 6.69037904605E-02 6.92078074103E-02 7.15870200834E-02 7.40436483737E-02 7.65799611994E-02 7.91982762497E-02 8.19009595872E-02 8.46904250953E-02 8.75691337524E-02 9.05395927210E-02 9.36043542307E-02 9.67660142394E-02 1.00027210853E-01 1.03390622481E-01 1.06858965709E-01 1.10434992859E-01 1.14121489219E-01 1.17921269911E-01 1.21837176367E-01 1.25872072388E-01 1.30028839750E-01 1.34310373322E-01 1.38719575666E-01 1.43259351073E-01 1.47932599003E-01 1.52742206877E-01 1.57691042190E-01 1.62781943891E-01 1.68017712973E-01 1.73401102248E-01 1.78934805227E-01 1.84621444067E-01 1.90463556528E-01 1.96463581882E-01 2.02623845702E-01 2.08946543503E-01 2.15433723134E-01 2.22087265902E-01 2.28908866331E-01 2.35900010518E-01 2.43061953031E-01 2.50395692269E-01 2.57901944262E-01 2.65581114837E-01 2.73433270119E-01 2.81458105334E-01 2.89654911871E-01 2.98022542599E-01 3.06559375429E-01 3.15263275113E-01 3.24131553333E-01 3.33160927095E-01 3.42347475502E-01 3.51686595001E-01 3.61172953215E-01 3.70800441498E-01 3.80562126429E-01 3.90450200424E-01 4.00455931778E-01 4.10569614421E-01 4.20780517772E-01 4.31076837109E-01 4.41445644949E-01 4.51872843987E-01 4.62343122209E-01 4.72839910884E-01 4.83345346202E-01 4.93840235395E-01 5.04304028272E-01 5.14714795166E-01 5.25049212351E-01 5.35282556073E-01 5.45388706374E-01 5.55340161953E-01 5.65108067300E-01 5.74662253382E-01 5.83971293103E-01 5.93002572713E-01 6.01722380243E-01 6.10096011888E-01 6.18087897053E-01 6.25661742510E-01 6.32780695746E-01 6.39407527194E-01 6.45504830457E-01 6.51035239069E-01 6.55961657575E-01 6.60247503912E-01 6.63856959128E-01 6.66755219460E-01 6.68908744692E-01 6.70285495587E-01 6.70855151995E-01 6.70589302150E-01 6.69461592676E-01 6.67447827999E-01 6.64526007434E-01 6.60676288212E-01 6.55880863396E-01 6.50123745137E-01 6.43390446415E-01 6.35667558392E-01 6.26942226257E-01 6.17201534121E-01 6.06431819572E-01 5.94617951065E-01 5.81742616699E-01 5.67785691146E-01 5.52723768386E-01 5.36529971059E-01 5.19174171723E-01 5.00623785651E-01 4.80845316690E-01 4.59806853804E-01 4.37481721717E-01 4.13853478232E-01 3.88922415637E-01 3.62713654037E-01 3.35286798815E-01 3.06746959276E-01 2.77256676697E-01 2.47047974554E-01 2.16433312498E-01 1.85813699405E-01 1.55681617910E-01 1.26615782928E-01 9.92642008350E-02 7.43116971768E-02 5.24283486856E-02 3.41965924715E-02 2.00179820967E-02 1.00068329321E-02 3.88918530491E-03 9.44350707653E-04 5.68231154400E-05 -5.59307945001E-06 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1.10739040530E+01 -5.29486839031E+01 -2.22756670672E+01 9.91102229647E+02 -3.91701838185E+03 7.26084796796E+03 -6.62951142087E+03 2.39291313101E+03 1S 0 1.00 Wavefunction 0.00000000000E+00 5.62074492579E-05 1.13375685884E-04 1.71521132467E-04 2.30660492333E-04 2.90810754272E-04 3.51989197408E-04 4.14213396161E-04 4.77501225289E-04 5.41870865018E-04 6.07340806258E-04 6.73929855911E-04 7.41657142261E-04 8.10542120468E-04 8.80604578149E-04 9.51864641049E-04 1.02434277882E-03 1.09805981089E-03 1.17303691243E-03 1.24929562043E-03 1.32685783990E-03 1.40574585009E-03 1.48598231094E-03 1.56759026954E-03 1.65059316678E-03 1.73501484400E-03 1.82087954989E-03 1.90821194740E-03 1.99703712083E-03 2.08738058300E-03 2.17926828260E-03 2.27272661156E-03 2.36778241266E-03 2.46446298721E-03 2.56279610286E-03 2.66281000155E-03 2.76453340760E-03 2.86799553597E-03 2.97322610054E-03 3.08025532271E-03 3.18911393998E-03 3.29983321478E-03 3.41244494339E-03 3.52698146508E-03 3.64347567129E-03 3.76196101511E-03 3.88247152079E-03 4.00504179350E-03 4.12970702919E-03 4.25650302469E-03 4.38546618790E-03 4.51663354819E-03 4.65004276700E-03 4.78573214857E-03 4.92374065090E-03 5.06410789684E-03 5.20687418541E-03 5.35208050327E-03 5.49976853647E-03 5.64998068226E-03 5.80276006121E-03 5.95815052951E-03 6.11619669143E-03 6.27694391202E-03 6.44043833008E-03 6.60672687119E-03 6.77585726117E-03 6.94787803955E-03 7.12283857344E-03 7.30078907150E-03 7.48178059827E-03 7.66586508858E-03 7.85309536236E-03 8.04352513958E-03 8.23720905551E-03 8.43420267616E-03 8.63456251406E-03 8.83834604425E-03 9.04561172052E-03 9.25641899195E-03 9.47082831971E-03 9.68890119416E-03 9.91070015216E-03 1.01362887948E-02 1.03657318051E-02 1.05990949665E-02 1.08364451815E-02 1.10778504898E-02 1.13233800882E-02 1.15731043496E-02 1.18270948429E-02 1.20854243530E-02 1.23481669013E-02 1.26153977661E-02 1.28871935042E-02 1.31636319716E-02 1.34447923460E-02 1.37307551482E-02 1.40216022649E-02 1.43174169711E-02 1.46182839540E-02 1.49242893355E-02 1.52355206968E-02 1.55520671025E-02 1.58740191248E-02 1.62014688692E-02 1.65345099992E-02 1.68732377625E-02 1.72177490172E-02 1.75681422579E-02 1.79245176431E-02 1.82869770228E-02 1.86556239655E-02 1.90305637871E-02 1.94119035794E-02 1.97997522389E-02 2.01942204966E-02 2.05954209475E-02 2.10034680815E-02 2.14184783139E-02 2.18405700163E-02 2.22698635491E-02 2.27064812927E-02 2.31505476808E-02 2.36021892330E-02 2.40615345886E-02 2.45287145403E-02 2.50038620686E-02 2.54871123769E-02 2.59786029268E-02 2.64784734734E-02 2.69868661025E-02 2.75039252663E-02 2.80297978216E-02 2.85646330664E-02 2.91085827791E-02 2.96618012564E-02 3.02244453523E-02 3.07966745182E-02 3.13786508423E-02 3.19705390903E-02 3.25725067464E-02 3.31847240541E-02 3.38073640585E-02 3.44406026482E-02 3.50846185982E-02 3.57395936125E-02 3.64057123679E-02 3.70831625577E-02 3.77721349359E-02 3.84728233622E-02 3.91854248462E-02 3.99101395936E-02 4.06471710513E-02 4.13967259535E-02 4.21590143682E-02 4.29342497435E-02 4.37226489547E-02 4.45244323512E-02 4.53398238039E-02 4.61690507526E-02 4.70123442538E-02 4.78699390283E-02 4.87420735092E-02 4.96289898899E-02 5.05309341721E-02 5.14481562136E-02 5.23809097767E-02 5.33294525754E-02 5.42940463238E-02 5.52749567832E-02 5.62724538095E-02 5.72868114005E-02 5.83183077421E-02 5.93672252550E-02 6.04338506402E-02 6.15184749246E-02 6.26213935051E-02 6.37429061931E-02 6.48833172575E-02 6.60429354667E-02 6.72220741304E-02 6.84210511398E-02 6.96401890068E-02 7.08798149017E-02 7.21402606904E-02 7.34218629687E-02 7.47249630966E-02 7.60499072298E-02 7.73970463494E-02 7.87667362905E-02 8.01593377675E-02 8.15752163980E-02 8.30147427235E-02 8.44782922287E-02 8.59662453561E-02 8.74789875199E-02 8.90169091147E-02 9.05804055221E-02 9.21698771136E-02 9.37857292490E-02 9.54283722717E-02 9.70982214992E-02 9.87956972095E-02 1.00521224622E-01 1.02275233876E-01 1.04058159998E-01 1.05870442873E-01 1.07712527199E-01 1.09584862445E-01 1.11487902796E-01 1.13422107095E-01 1.15387938777E-01 1.17385865796E-01 1.19416360540E-01 1.21479899746E-01 1.23576964403E-01 1.25708039639E-01 1.27873614614E-01 1.30074182390E-01 1.32310239794E-01 1.34582287281E-01 1.36890828769E-01 1.39236371479E-01 1.41619425753E-01 1.44040504864E-01 1.46500124816E-01 1.48998804128E-01 1.51537063606E-01 1.54115426099E-01 1.56734416247E-01 1.59394560213E-01 1.62096385393E-01 1.64840420122E-01 1.67627193358E-01 1.70457234352E-01 1.73331072302E-01 1.76249235991E-01 1.79212253408E-01 1.82220651350E-01 1.85274955013E-01 1.88375687558E-01 1.91523369665E-01 1.94718519066E-01 1.97961650060E-01 2.01253273014E-01 2.04593893840E-01 2.07984013455E-01 2.11424127226E-01 2.14914724393E-01 2.18456287474E-01 2.22049291649E-01 2.25694204131E-01 2.29391483511E-01 2.33141579089E-01 2.36944930182E-01 2.40801965413E-01 2.44713101983E-01 2.48678744915E-01 2.52699286287E-01 2.56775104433E-01 2.60906563125E-01 2.65094010734E-01 2.69337779354E-01 2.73638183913E-01 2.77995521235E-01 2.82410069083E-01 2.86882085155E-01 2.91411806043E-01 2.95999446138E-01 3.00645196485E-01 3.05349223576E-01 3.10111668068E-01 3.14932643428E-01 3.19812234472E-01 3.24750495812E-01 3.29747450167E-01 3.34803086544E-01 3.39917358244E-01 3.45090180699E-01 3.50321429081E-01 3.55610935678E-01 3.60958486994E-01 3.66363820530E-01 3.71826621213E-01 3.77346517426E-01 3.82923076581E-01 3.88555800185E-01 3.94244118341E-01 3.99987383605E-01 4.05784864149E-01 4.11635736136E-01 4.17539075235E-01 4.23493847197E-01 4.29498897397E-01 4.35552939254E-01 4.41654541457E-01 4.47802113881E-01 4.53993892143E-01 4.60227920695E-01 4.66502034411E-01 4.72813838609E-01 4.79160687485E-01 4.85539660957E-01 4.91947539969E-01 4.98380780327E-01 5.04835485209E-01 5.11307376569E-01 5.17791765714E-01 5.24283523457E-01 5.30777050351E-01 5.37266247649E-01 5.43744489798E-01 5.50204599458E-01 5.56638826216E-01 5.63038830445E-01 5.69395673946E-01 5.75699819328E-01 5.81941140347E-01 5.88108945708E-01 5.94192019128E-01 6.00178678724E-01 6.06056858964E-01 6.11814218609E-01 6.17438277983E-01 6.22916588801E-01 6.28236939234E-01 6.33387596074E-01 6.38357584480E-01 6.43137003676E-01 6.47717373970E-01 6.52092006193E-01 6.56256378792E-01 6.60208499834E-01 6.63949220524E-01 6.67482452682E-01 6.70815224103E-01 6.73957481470E-01 6.76921519222E-01 6.79720872347E-01 6.82368459404E-01 6.84873696026E-01 6.87238804971E-01 6.89460589077E-01 6.91535332087E-01 6.93459349835E-01 6.95228997365E-01 6.96840674010E-01 6.98290829173E-01 6.99575968234E-01 7.00692658617E-01 7.01637535956E-01 7.02407310419E-01 7.02998773124E-01 7.03408802686E-01 7.03634371859E-01 7.03672554283E-01 7.03520531312E-01 7.03175598941E-01 7.02635174779E-01 7.01896805115E-01 7.00958172004E-01 6.99817100430E-01 6.98471565457E-01 6.96919699438E-01 6.95159799190E-01 6.93190333189E-01 6.91009948708E-01 6.88617478940E-01 6.86011950033E-01 6.83192588069E-01 6.80158825915E-01 6.76910309985E-01 6.73446906813E-01 6.69768709497E-01 6.65876043904E-01 6.61769474684E-01 6.57449810983E-01 6.52918111902E-01 6.48175691590E-01 6.43224124001E-01 6.38065247206E-01 6.32701167297E-01 6.27134261745E-01 6.21367182264E-01 6.15402857038E-01 6.09244492346E-01 6.02895573459E-01 5.96359864832E-01 5.89641409464E-01 5.82744527461E-01 5.75673813670E-01 5.68434134419E-01 5.61030623265E-01 5.53468675763E-01 5.45753943187E-01 5.37892325238E-01 5.29889961665E-01 5.21753222880E-01 5.13488699499E-01 5.05103190904E-01 4.96603692815E-01 4.87997383958E-01 4.79291611864E-01 4.70493877908E-01 4.61611821640E-01 4.52653204549E-01 4.43625893325E-01 4.34537842789E-01 4.25397078562E-01 4.16211679646E-01 4.06989761022E-01 3.97739456401E-01 3.88468901262E-01 3.79186216285E-01 3.69899491313E-01 3.60616769909E-01 3.51346034641E-01 3.42095193124E-01 3.32872064921E-01 3.23684369274E-01 3.14539713767E-01 3.05445583826E-01 2.96409333104E-01 2.87438174638E-01 2.78539172783E-01 2.69719235744E-01 2.60985108705E-01 2.52343367330E-01 2.43800411614E-01 2.35362459844E-01 2.27035542639E-01 2.18825496832E-01 2.10737959173E-01 2.02778359641E-01 1.94951914376E-01 1.87263618073E-01 1.79718235885E-01 1.72320294741E-01 1.65074074199E-01 1.57983596804E-01 1.51052618126E-01 1.44284616528E-01 1.37682782890E-01 1.31250010385E-01 1.24988884584E-01 1.18901674013E-01 1.12990321437E-01 1.07256436031E-01 1.01701286678E-01 9.63257965359E-02 9.11305390839E-02 8.61157357573E-02 8.12812553162E-02 7.66266150056E-02 7.21509835992E-02 6.78531863187E-02 6.37317116576E-02 5.97847200487E-02 5.60100543396E-02 5.24052519706E-02 4.89675587664E-02 4.56939441985E-02 4.25811179922E-02 3.96255479079E-02 3.68234785445E-02 3.41709509829E-02 3.16638231023E-02 2.92977903851E-02 2.70684070418E-02 2.49711072778E-02 2.30012265405E-02 2.11540225834E-02 1.94246961997E-02 1.78084114826E-02 1.63003154837E-02 1.48955571502E-02 1.35893054366E-02 1.23767664956E-02 1.12531998706E-02 1.02139336188E-02 9.25437831424E-03 8.37003988538E-03 7.55653125924E-03 6.80958279378E-03 6.12505149159E-03 5.49892899895E-03 4.92734840417E-03 4.40658985822E-03 3.93308504944E-03 3.50342057123E-03 3.11434022899E-03 2.76274633803E-03 2.44570006962E-03 2.16042090627E-03 1.90428527100E-03 1.67482439759E-03 1.46972151103E-03 1.28680838783E-03 1.12406136660E-03 9.79596878658E-04 8.51666567360E-04 7.38652063470E-04 6.39059481386E-04 5.51513698699E-04 4.74752473261E-04 4.07620423577E-04 3.49063102449E-04 2.98120917343E-04 2.53923136765E-04 2.15681987011E-04 1.82686868790E-04 1.54298725018E-04 1.29944586850E-04 1.09112320937E-04 9.13455969012E-05 7.62390901354E-05 6.34339314194E-05 5.26134113499E-05 4.34989443948E-05 3.58462944088E-05 2.94420607617E-05 2.41004218139E-05 1.96601303402E-05 1.59817536469E-05 1.29451495436E-05 1.04471680112E-05 8.39956733223E-06 6.72713260610E-06 5.36598392916E-06 4.26206105363E-06 3.36977101488E-06 2.65078498828E-06 2.07297045528E-06 1.60944455564E-06 1.23773419263E-06 9.39027925651E-07 6.97503772371E-07 4.99715528880E-07 3.34017787334E-07 1.90006030242E-07 5.79423419176E-08 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 4.42867113373E-09 1.80187861066E-08 4.12402170829E-08 7.45816687412E-08 1.18551372515E-07 1.73677805530E-07 2.40510435104E-07 3.19620489699E-07 4.11601757259E-07 5.17071411881E-07 6.36670869814E-07 7.71066675814E-07 9.20951420902E-07 1.08704469264E-06 1.27009405905E-06 1.47087608733E-06 1.69019739864E-06 1.92889576015E-06 2.18784121564E-06 2.46793725614E-06 2.77012203178E-06 3.09536960645E-06 3.44469125675E-06 3.81913681665E-06 4.21979606963E-06 4.64780018978E-06 5.10432323371E-06 5.59058368490E-06 6.10784605243E-06 6.65742252595E-06 7.24067468874E-06 7.85901529107E-06 8.51391008581E-06 9.20687972844E-06 9.93950174383E-06 1.07134125620E-05 1.15303096252E-05 1.23919535691E-05 1.33001704800E-05 1.42568542317E-05 1.52639689034E-05 1.63235512834E-05 1.74377134591E-05 1.86086454988E-05 1.98386182263E-05 2.11299860933E-05 2.24851901516E-05 2.39067611297E-05 2.53973226160E-05 2.69595943543E-05 2.85963956531E-05 3.03106489148E-05 3.21053832875E-05 3.39837384442E-05 3.59489684937E-05 3.80044460282E-05 4.01536663109E-05 4.24002516107E-05 4.47479556867E-05 4.72006684291E-05 4.97624206619E-05 5.24373891122E-05 5.52299015522E-05 5.81444421202E-05 6.11856568262E-05 6.43583592489E-05 6.76675364302E-05 7.11183549747E-05 7.47161673600E-05 7.84665184671E-05 8.23751523357E-05 8.64480191550E-05 9.06912824955E-05 9.51113267922E-05 9.97147650865E-05 1.04508447036E-04 1.09499467199E-04 1.14695173614E-04 1.20103176662E-04 1.25731358248E-04 1.31587881291E-04 1.37681199546E-04 1.44020067767E-04 1.50613552210E-04 1.57471041514E-04 1.64602257942E-04 1.72017269020E-04 1.79726499569E-04 1.87740744162E-04 1.96071179991E-04 2.04729380200E-04 2.13727327656E-04 2.23077429205E-04 2.32792530413E-04 2.42885930812E-04 2.53371399674E-04 2.64263192320E-04 2.75576066992E-04 2.87325302298E-04 2.99526715260E-04 3.12196679976E-04 3.25352146919E-04 3.39010662894E-04 3.53190391686E-04 3.67910135397E-04 3.83189356524E-04 3.99048200778E-04 4.15507520691E-04 4.32588900017E-04 4.50314678965E-04 4.68707980291E-04 4.87792736272E-04 5.07593716597E-04 5.28136557201E-04 5.49447790077E-04 5.71554874093E-04 5.94486226851E-04 6.18271257623E-04 6.42940401392E-04 6.68525154046E-04 6.95058108751E-04 7.22572993543E-04 7.51104710192E-04 7.80689374355E-04 8.11364357086E-04 8.43168327717E-04 8.76141298193E-04 9.10324668859E-04 9.45761275793E-04 9.82495439697E-04 1.02057301642E-03 1.06004144914E-03 1.10094982230E-03 1.14334891730E-03 1.18729127000E-03 1.23283123019E-03 1.28002502295E-03 1.32893081202E-03 1.37960876527E-03 1.43212112230E-03 1.48653226422E-03 1.54290878571E-03 1.60131956941E-03 1.66183586273E-03 1.72453135708E-03 1.78948226974E-03 1.85676742822E-03 1.92646835747E-03 1.99866936973E-03 2.07345765731E-03 2.15092338825E-03 2.23115980509E-03 2.31426332659E-03 2.40033365280E-03 2.48947387325E-03 2.58179057861E-03 2.67739397573E-03 2.77639800626E-03 2.87892046886E-03 2.98508314514E-03 3.09501192945E-03 3.20883696255E-03 3.32669276924E-03 3.44871840017E-03 3.57505757782E-03 3.70585884669E-03 3.84127572799E-03 3.98146687874E-03 4.12659625544E-03 4.27683328245E-03 4.43235302512E-03 4.59333636769E-03 4.75997019627E-03 4.93244758674E-03 5.11096799779E-03 5.29573746919E-03 5.48696882522E-03 5.68488188361E-03 5.88970366973E-03 6.10166863634E-03 6.32101888887E-03 6.54800441620E-03 6.78288332718E-03 7.02592209269E-03 7.27739579346E-03 7.53758837350E-03 7.80679289931E-03 8.08531182468E-03 8.37345726118E-03 8.67155125428E-03 8.97992606496E-03 9.29892445683E-03 9.62889998863E-03 9.97021731195E-03 1.03232524740E-02 1.06883932257E-02 1.10660393335E-02 1.14566028973E-02 1.18605086711E-02 1.22781943881E-02 1.27101110901E-02 1.31567234590E-02 1.36185101522E-02 1.40959641389E-02 1.45895930402E-02 1.50999194684E-02 1.56274813684E-02 1.61728323581E-02 1.67365420686E-02 1.73191964820E-02 1.79213982672E-02 1.85437671117E-02 1.91869400490E-02 1.98515717798E-02 2.05383349859E-02 2.12479206367E-02 2.19810382841E-02 2.27384163469E-02 2.35208023815E-02 2.43289633376E-02 2.51636857963E-02 2.60257761895E-02 2.69160609974E-02 2.78353869221E-02 2.87846210345E-02 2.97646508924E-02 3.07763846255E-02 3.18207509863E-02 3.28986993608E-02 3.40111997389E-02 3.51592426377E-02 3.63438389759E-02 3.75660198945E-02 3.88268365195E-02 4.01273596625E-02 4.14686794546E-02 4.28519049079E-02 4.42781634012E-02 4.57486000834E-02 4.72643771896E-02 4.88266732653E-02 5.04366822918E-02 5.20956127083E-02 5.38046863240E-02 5.55651371157E-02 5.73782099035E-02 5.92451589011E-02 6.11672461328E-02 6.31457397134E-02 6.51819119861E-02 6.72770375119E-02 6.94323909084E-02 7.16492445323E-02 7.39288660037E-02 7.62725155690E-02 7.86814433019E-02 8.11568861405E-02 8.37000647631E-02 8.63121803037E-02 8.89944109109E-02 9.17479081567E-02 9.45737933017E-02 9.74731534263E-02 1.00447037441E-01 1.03496451987E-01 1.06622357254E-01 1.09825662718E-01 1.13107222840E-01 1.16467832744E-01 1.19908223904E-01 1.23429059874E-01 1.27030932098E-01 1.30714355841E-01 1.34479766275E-01 1.38327514782E-01 1.42257865495E-01 1.46270992155E-01 1.50366975301E-01 1.54545799864E-01 1.58807353192E-01 1.63151423548E-01 1.67577699124E-01 1.72085767568E-01 1.76675116054E-01 1.81345131869E-01 1.86095103498E-01 1.90924222132E-01 1.95831583526E-01 2.00816190064E-01 2.05876952866E-01 2.11012693706E-01 2.16222146463E-01 2.21503957756E-01 2.26856686340E-01 2.32278800782E-01 2.37768674824E-01 2.43324579797E-01 2.48944673344E-01 2.54626983646E-01 2.60369388296E-01 2.66169586913E-01 2.72025066580E-01 2.77933059234E-01 2.83890490206E-01 2.89893917280E-01 2.95939459868E-01 3.02022718284E-01 3.08138683565E-01 3.14281638951E-01 3.20445054956E-01 3.26621481019E-01 3.32802437939E-01 3.38978316826E-01 3.45138291953E-01 3.51270256840E-01 3.57360794875E-01 3.63395197882E-01 3.69357547968E-01 3.75230879558E-01 3.80997439473E-01 3.86639062720E-01 3.92137679841E-01 3.97475967545E-01 4.02638146990E-01 4.07610922648E-01 4.12384538079E-01 4.16953902123E-01 4.21319709316E-01 4.25489441417E-01 4.29478093709E-01 4.33308422982E-01 4.37010469772E-01 4.40620076530E-01 4.44176125021E-01 4.47716281350E-01 4.51271214802E-01 4.54857623083E-01 4.58471066541E-01 4.62080759434E-01 4.65630340711E-01 4.69051620532E-01 4.72297173187E-01 4.75355902008E-01 4.78221113631E-01 4.80885867970E-01 4.83343356863E-01 4.85586923032E-01 4.87610080176E-01 4.89406533393E-01 4.90970199895E-01 4.92295229913E-01 4.93376027777E-01 4.94207273057E-01 4.94783941737E-01 4.95101327301E-01 4.95155061690E-01 4.94941136018E-01 4.94455920988E-01 4.93696186882E-01 4.92659123080E-01 4.91342356954E-01 4.89743972115E-01 4.87862525820E-01 4.85697065541E-01 4.83247144496E-01 4.80512836124E-01 4.77494747322E-01 4.74194030424E-01 4.70612393724E-01 4.66752110544E-01 4.62616026639E-01 4.58207565950E-01 4.53530734500E-01 4.48590122445E-01 4.43390904089E-01 4.37938835889E-01 4.32240252250E-01 4.26302059162E-01 4.20131725505E-01 4.13737272059E-01 4.07127258080E-01 4.00310765514E-01 3.93297380697E-01 3.86097173666E-01 3.78720674951E-01 3.71178849984E-01 3.63483071057E-01 3.55645086974E-01 3.47676990378E-01 3.39591182942E-01 3.31400338433E-01 3.23117363894E-01 3.14755358995E-01 3.06327573838E-01 2.97847365325E-01 2.89328152404E-01 2.80783370361E-01 2.72226424508E-01 2.63670643469E-01 2.55129232452E-01 2.46615226741E-01 2.38141445807E-01 2.29720448293E-01 2.21364488272E-01 2.13085473034E-01 2.04894922777E-01 1.96803932449E-01 1.88823136068E-01 1.80962673732E-01 1.73232161588E-01 1.65640664921E-01 1.58196674552E-01 1.50908086650E-01 1.43782186051E-01 1.36825633132E-01 1.30044454224E-01 1.23444035569E-01 1.17029120695E-01 1.10803811166E-01 1.04771570497E-01 9.89352311452E-02 9.32970043096E-02 8.78584924031E-02 8.26207039121E-02 7.75840704673E-02 7.27484658424E-02 6.81132266960E-02 6.36771747834E-02 5.94386404676E-02 5.53954872843E-02 5.15451374171E-02 4.78845978743E-02 4.44104872607E-02 4.11190629757E-02 3.80062487682E-02 3.50676625150E-02 3.22986441818E-02 2.96942838621E-02 2.72494498649E-02 2.49588167603E-02 2.28168933524E-02 2.08180504843E-02 1.89565486292E-02 1.72265651578E-02 1.56222212078E-02 1.41376080270E-02 1.27668126878E-02 1.15039430245E-02 1.03431516711E-02 9.27865904154E-03 8.30477512083E-03 7.41591991566E-03 6.60664243961E-03 5.87163810397E-03 5.20576441373E-03 4.60405487537E-03 4.06173105472E-03 3.57421273714E-03 3.13712617471E-03 2.74631042323E-03 2.39782180204E-03 2.08793652814E-03 1.81315160228E-03 1.57018404078E-03 1.35596856675E-03 1.16765388646E-03 1.00259768949E-03 8.58360518051E-04 7.32698656880E-04 6.23556196212E-04 5.29056420274E-04 4.47492669686E-04 3.77318820956E-04 3.17139518278E-04 2.65700283817E-04 2.21877621938E-04 1.84669221518E-04 1.53184348281E-04 1.26634506825E-04 1.04324439555E-04 8.56435176440E-05 7.00575674054E-05 5.71011644458E-05 4.63704176417E-05 3.75162556261E-05 3.02382200158E-05 2.42787621999E-05 1.94180341017E-05 1.54691579449E-05 1.22739556503E-05 9.69911502349E-06 7.63276729806E-06 5.98144880684E-06 4.66741847378E-06 3.62630237897E-06 2.80503675164E-06 2.16008131142E-06 1.65587582043E-06 1.26351395089E-06 9.59610040876E-07 7.25335939087E-07 5.45606868708E-07 4.08397019133E-07 3.04167358648E-07 2.25389909975E-07 1.66154409059E-07 1.21845049009E-07 8.88760810053E-08 6.44769591294E-08 4.65187193366E-08 3.33744918961E-08 2.38080964480E-08 1.68855955847E-08 1.19054985332E-08 8.34401804020E-09 5.81239884166E-09 4.02386363939E-09 2.76817104292E-09 1.89215815597E-09 1.28495681776E-09 8.66834938463E-10 5.80830329306E-10 3.86520723461E-10 2.55416448618E-10 1.67576896043E-10 1.09143319023E-10 7.05527310893E-11 4.52543129209E-11 2.87937834140E-11 1.81651643529E-11 1.13553566478E-11 7.02666102628E-12 4.29720649144E-12 2.59031176742E-12 1.53198592554E-12 8.81773441662E-13 4.86511510545E-13 2.49715608815E-13 1.11567881813E-13 3.61022913852E-14 3.35731497360E-15 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 TDDFPT/Examples/pseudo/C.pbe-van_ak.UPF0000644000175000017500000101270012341371476015751 0ustar mbamba Generated using Vanderbilt code, version 7 3 4 Author: unknown Generation date: 4 3 5 Automatically converted from original format 0 The Pseudo was generated with a Non-Relativistic Calculation 1.00000000000E+00 Local Potential cutoff radius nl pn l occ Rcut Rcut US E pseu 2S 2 0 2.00 10.00000000000 1.10000000000 -1.00978244769 2P 2 1 2.00 10.00000000000 1.10000000000 -0.38870429969 0 Version Number C Element US Ultrasoft pseudopotential F Nonlinear Core Correction SLA PW PBE PBE PBE Exchange-Correlation functional 4.00000000000 Z valence -10.72515811861 Total energy 0.0000000 0.0000000 Suggested cutoff for wfc and rho 1 Max angular momentum component 721 Number of points in mesh 2 4 Number of Wavefunctions, Number of Projectors Wavefunctions nl l occ 2S 0 2.00 2P 1 2.00 0.00000000000E+00 7.06180151333E-06 1.42443146680E-05 2.15496028610E-05 2.89797647603E-05 3.65369349077E-05 4.42232843318E-05 5.20410211722E-05 5.99923913133E-05 6.80796790299E-05 7.63052076433E-05 8.46713401887E-05 9.31804800941E-05 1.01835071871E-04 1.10637601815E-04 1.19590598724E-04 1.28696634621E-04 1.37958325492E-04 1.47378332043E-04 1.56959360459E-04 1.66704163185E-04 1.76615539714E-04 1.86696337391E-04 1.96949452236E-04 2.07377829770E-04 2.17984465864E-04 2.28772407599E-04 2.39744754143E-04 2.50904657637E-04 2.62255324107E-04 2.73800014379E-04 2.85542045019E-04 2.97484789285E-04 3.09631678098E-04 3.21986201022E-04 3.34551907273E-04 3.47332406736E-04 3.60331371001E-04 3.73552534418E-04 3.86999695173E-04 4.00676716373E-04 4.14587527163E-04 4.28736123849E-04 4.43126571050E-04 4.57763002861E-04 4.72649624048E-04 4.87790711249E-04 5.03190614203E-04 5.18853757007E-04 5.34784639377E-04 5.50987837948E-04 5.67468007585E-04 5.84229882722E-04 6.01278278721E-04 6.18618093257E-04 6.36254307723E-04 6.54191988661E-04 6.72436289222E-04 6.90992450638E-04 7.09865803737E-04 7.29061770466E-04 7.48585865457E-04 7.68443697604E-04 7.88640971677E-04 8.09183489964E-04 8.30077153930E-04 8.51327965923E-04 8.72942030889E-04 8.94925558131E-04 9.17284863090E-04 9.40026369163E-04 9.63156609543E-04 9.86682229102E-04 1.01060998630E-03 1.03494675510E-03 1.05969952701E-03 1.08487541301E-03 1.11048164564E-03 1.13652558108E-03 1.16301470125E-03 1.18995661596E-03 1.21735906511E-03 1.24522992088E-03 1.27357719003E-03 1.30240901618E-03 1.33173368217E-03 1.36155961239E-03 1.39189537527E-03 1.42274968567E-03 1.45413140745E-03 1.48604955597E-03 1.51851330069E-03 1.55153196782E-03 1.58511504299E-03 1.61927217395E-03 1.65401317340E-03 1.68934802175E-03 1.72528687002E-03 1.76184004274E-03 1.79901804094E-03 1.83683154513E-03 1.87529141840E-03 1.91440870953E-03 1.95419465616E-03 1.99466068802E-03 2.03581843021E-03 2.07767970658E-03 2.12025654304E-03 2.16356117109E-03 2.20760603133E-03 2.25240377699E-03 2.29796727758E-03 2.34430962263E-03 2.39144412539E-03 2.43938432670E-03 2.48814399884E-03 2.53773714952E-03 2.58817802591E-03 2.63948111868E-03 2.69166116622E-03 2.74473315885E-03 2.79871234313E-03 2.85361422623E-03 2.90945458039E-03 2.96624944748E-03 3.02401514356E-03 3.08276826360E-03 3.14252568623E-03 3.20330457859E-03 3.26512240130E-03 3.32799691342E-03 3.39194617757E-03 3.45698856514E-03 3.52314276156E-03 3.59042777163E-03 3.65886292505E-03 3.72846788191E-03 3.79926263836E-03 3.87126753238E-03 3.94450324956E-03 4.01899082913E-03 4.09475166991E-03 4.17180753653E-03 4.25018056564E-03 4.32989327232E-03 4.41096855646E-03 4.49342970944E-03 4.57730042075E-03 4.66260478481E-03 4.74936730793E-03 4.83761291529E-03 4.92736695815E-03 5.01865522111E-03 5.11150392953E-03 5.20593975703E-03 5.30198983321E-03 5.39968175139E-03 5.49904357658E-03 5.60010385349E-03 5.70289161480E-03 5.80743638944E-03 5.91376821109E-03 6.02191762684E-03 6.13191570591E-03 6.24379404863E-03 6.35758479548E-03 6.47332063634E-03 6.59103481988E-03 6.71076116310E-03 6.83253406107E-03 6.95638849678E-03 7.08236005122E-03 7.21048491357E-03 7.34079989163E-03 7.47334242237E-03 7.60815058269E-03 7.74526310038E-03 7.88471936520E-03 8.02655944024E-03 8.17082407341E-03 8.31755470914E-03 8.46679350032E-03 8.61858332035E-03 8.77296777551E-03 8.92999121747E-03 9.08969875603E-03 9.25213627207E-03 9.41735043075E-03 9.58538869490E-03 9.75629933865E-03 9.93013146133E-03 1.01069350016E-02 1.02867607515E-02 1.04696603718E-02 1.06556864057E-02 1.08448922951E-02 1.10373323951E-02 1.12330619901E-02 1.14321373093E-02 1.16346155433E-02 1.18405548601E-02 1.20500144221E-02 1.22630544030E-02 1.24797360050E-02 1.27001214767E-02 1.29242741304E-02 1.31522583609E-02 1.33841396636E-02 1.36199846535E-02 1.38598610845E-02 1.41038378682E-02 1.43519850946E-02 1.46043740515E-02 1.48610772453E-02 1.51221684220E-02 1.53877225880E-02 1.56578160319E-02 1.59325263462E-02 1.62119324499E-02 1.64961146111E-02 1.67851544697E-02 1.70791350612E-02 1.73781408408E-02 1.76822577068E-02 1.79915730262E-02 1.83061756593E-02 1.86261559854E-02 1.89516059285E-02 1.92826189843E-02 1.96192902462E-02 1.99617164336E-02 2.03099959187E-02 2.06642287555E-02 2.10245167083E-02 2.13909632809E-02 2.17636737461E-02 2.21427551767E-02 2.25283164752E-02 2.29204684060E-02 2.33193236268E-02 2.37249967210E-02 2.41376042305E-02 2.45572646896E-02 2.49840986585E-02 2.54182287584E-02 2.58597797065E-02 2.63088783519E-02 2.67656537118E-02 2.72302370090E-02 2.77027617093E-02 2.81833635599E-02 2.86721806284E-02 2.91693533424E-02 2.96750245302E-02 3.01893394612E-02 3.07124458881E-02 3.12444940894E-02 3.17856369121E-02 3.23360298162E-02 3.28958309188E-02 3.34652010400E-02 3.40443037488E-02 3.46333054102E-02 3.52323752330E-02 3.58416853183E-02 3.64614107092E-02 3.70917294408E-02 3.77328225914E-02 3.83848743346E-02 3.90480719925E-02 3.97226060887E-02 4.04086704038E-02 4.11064620310E-02 4.18161814322E-02 4.25380324961E-02 4.32722225965E-02 4.40189626520E-02 4.47784671866E-02 4.55509543912E-02 4.63366461865E-02 4.71357682865E-02 4.79485502636E-02 4.87752256142E-02 4.96160318262E-02 5.04712104470E-02 5.13410071528E-02 5.22256718194E-02 5.31254585938E-02 5.40406259673E-02 5.49714368499E-02 5.59181586455E-02 5.68810633289E-02 5.78604275241E-02 5.88565325833E-02 5.98696646684E-02 6.09001148325E-02 6.19481791040E-02 6.30141585716E-02 6.40983594705E-02 6.52010932706E-02 6.63226767660E-02 6.74634321660E-02 6.86236871875E-02 6.98037751494E-02 7.10040350680E-02 7.22248117548E-02 7.34664559153E-02 7.47293242499E-02 7.60137795562E-02 7.73201908334E-02 7.86489333881E-02 8.00003889424E-02 8.13749457432E-02 8.27729986742E-02 8.41949493690E-02 8.56412063263E-02 8.71121850280E-02 8.86083080576E-02 9.01300052224E-02 9.16777136765E-02 9.32518780467E-02 9.48529505598E-02 9.64813911731E-02 9.81376677059E-02 9.98222559746E-02 1.01535639929E-01 1.03278311790E-01 1.05050772195E-01 1.06853530337E-01 1.08687104114E-01 1.10552020275E-01 1.12448814575E-01 1.14378031927E-01 1.16340226556E-01 1.18335962165E-01 1.20365812088E-01 1.22430359463E-01 1.24530197394E-01 1.26665929124E-01 1.28838168207E-01 1.31047538686E-01 1.33294675270E-01 1.35580223517E-01 1.37904840022E-01 1.40269192602E-01 1.42673960489E-01 1.45119834528E-01 1.47607517369E-01 1.50137723677E-01 1.52711180331E-01 1.55328626634E-01 1.57990814529E-01 1.60698508811E-01 1.63452487348E-01 1.66253541304E-01 1.69102475368E-01 1.72000107985E-01 1.74947271586E-01 1.77944812837E-01 1.80993592872E-01 1.84094487546E-01 1.87248387687E-01 1.90456199350E-01 1.93718844076E-01 1.97037259161E-01 2.00412397920E-01 2.03845229965E-01 2.07336741484E-01 2.10887935519E-01 2.14499832260E-01 2.18173469335E-01 2.21909902109E-01 2.25710203987E-01 2.29575466721E-01 2.33506800728E-01 2.37505335403E-01 2.41572219447E-01 2.45708621199E-01 2.49915728965E-01 2.54194751368E-01 2.58546917686E-01 2.62973478214E-01 2.67475704616E-01 2.72054890295E-01 2.76712350763E-01 2.81449424017E-01 2.86267470928E-01 2.91167875626E-01 2.96152045904E-01 3.01221413616E-01 3.06377435095E-01 3.11621591564E-01 3.16955389570E-01 3.22380361409E-01 3.27898065571E-01 3.33510087184E-01 3.39218038475E-01 3.45023559227E-01 3.50928317254E-01 3.56934008879E-01 3.63042359420E-01 3.69255123689E-01 3.75574086492E-01 3.82001063146E-01 3.88537899996E-01 3.95186474950E-01 4.01948698013E-01 4.08826511842E-01 4.15821892299E-01 4.22936849023E-01 4.30173426002E-01 4.37533702165E-01 4.45019791977E-01 4.52633846047E-01 4.60378051745E-01 4.68254633831E-01 4.76265855095E-01 4.84414017007E-01 4.92701460374E-01 5.01130566020E-01 5.09703755463E-01 5.18423491615E-01 5.27292279486E-01 5.36312666909E-01 5.45487245267E-01 5.54818650237E-01 5.64309562551E-01 5.73962708767E-01 5.83780862044E-01 5.93766842950E-01 6.03923520263E-01 6.14253811799E-01 6.24760685253E-01 6.35447159044E-01 6.46316303191E-01 6.57371240187E-01 6.68615145904E-01 6.80051250496E-01 6.91682839336E-01 7.03513253954E-01 7.15545892999E-01 7.27784213216E-01 7.40231730437E-01 7.52892020593E-01 7.65768720740E-01 7.78865530106E-01 7.92186211149E-01 8.05734590644E-01 8.19514560779E-01 8.33530080271E-01 8.47785175509E-01 8.62283941705E-01 8.77030544075E-01 8.92029219032E-01 9.07284275405E-01 9.22800095676E-01 9.38581137241E-01 9.54631933687E-01 9.70957096097E-01 9.87561314376E-01 1.00444935859E+00 1.02162608036E+00 1.03909641421E+00 1.05686537903E+00 1.07493807951E+00 1.09331970758E+00 1.11201554394E+00 1.13103095952E+00 1.15037141709E+00 1.17004247279E+00 1.19004977774E+00 1.21039907964E+00 1.23109622446E+00 1.25214715808E+00 1.27355792804E+00 1.29533468523E+00 1.31748368568E+00 1.34001129239E+00 1.36292397710E+00 1.38622832218E+00 1.40993102251E+00 1.43403888742E+00 1.45855884264E+00 1.48349793227E+00 1.50886332083E+00 1.53466229531E+00 1.56090226726E+00 1.58759077490E+00 1.61473548534E+00 1.64234419671E+00 1.67042484048E+00 1.69898548366E+00 1.72803433118E+00 1.75757972820E+00 1.78763016256E+00 1.81819426715E+00 1.84928082245E+00 1.88089875903E+00 1.91305716011E+00 1.94576526417E+00 1.97903246763E+00 2.01286832750E+00 2.04728256417E+00 2.08228506419E+00 2.11788588310E+00 2.15409524833E+00 2.19092356211E+00 2.22838140453E+00 2.26647953648E+00 2.30522890283E+00 2.34464063551E+00 2.38472605677E+00 2.42549668235E+00 2.46696422488E+00 2.50914059718E+00 2.55203791570E+00 2.59566850401E+00 2.64004489634E+00 2.68517984116E+00 2.73108630487E+00 2.77777747552E+00 2.82526676656E+00 2.87356782075E+00 2.92269451406E+00 2.97266095963E+00 3.02348151185E+00 3.07517077048E+00 3.12774358485E+00 3.18121505812E+00 3.23560055159E+00 3.29091568917E+00 3.34717636184E+00 3.40439873218E+00 3.46259923908E+00 3.52179460242E+00 3.58200182789E+00 3.64323821185E+00 3.70552134633E+00 3.76886912407E+00 3.83329974366E+00 3.89883171478E+00 3.96548386348E+00 4.03327533764E+00 4.10222561245E+00 4.17235449597E+00 4.24368213489E+00 4.31622902025E+00 4.39001599336E+00 4.46506425180E+00 4.54139535549E+00 4.61903123286E+00 4.69799418720E+00 4.77830690305E+00 4.85999245269E+00 4.94307430280E+00 5.02757632118E+00 5.11352278364E+00 5.20093838093E+00 5.28984822585E+00 5.38027786049E+00 5.47225326353E+00 5.56580085772E+00 5.66094751747E+00 5.75772057659E+00 5.85614783610E+00 5.95625757224E+00 6.05807854460E+00 6.16164000439E+00 6.26697170280E+00 6.37410389959E+00 6.48306737176E+00 6.59389342243E+00 6.70661388976E+00 6.82126115617E+00 6.93786815759E+00 7.05646839296E+00 7.17709593384E+00 7.29978543417E+00 7.42457214029E+00 7.55149190100E+00 7.68058117788E+00 7.81187705580E+00 7.94541725351E+00 8.08124013453E+00 8.21938471814E+00 8.35989069061E+00 8.50279841659E+00 8.64814895071E+00 8.79598404935E+00 8.94634618268E+00 9.09927854683E+00 9.25482507631E+00 9.41303045663E+00 9.57394013714E+00 9.73760034406E+00 9.90405809382E+00 1.00733612065E+01 1.02455583196E+01 1.04206989020E+01 1.05988332683E+01 1.07800125929E+01 1.09642889253E+01 1.11517152044E+01 1.13423452741E+01 1.15362338988E+01 1.17334367790E+01 1.19340105672E+01 1.21380128844E+01 1.23455023365E+01 1.25565385312E+01 1.27711820951E+01 1.29894946912E+01 1.32115390364E+01 1.34373789198E+01 1.36670792209E+01 1.39007059280E+01 1.41383261576E+01 1.43800081734E+01 1.46258214060E+01 1.48758364728E+01 1.51301251982E+01 1.53887606344E+01 1.56518170825E+01 1.59193701134E+01 1.61914965900E+01 1.64682746890E+01 1.67497839232E+01 1.70361051650E+01 1.73273206688E+01 1.76235140951E+01 1.79247705348E+01 1.82311765328E+01 1.85428201138E+01 1.88597908068E+01 1.91821796715E+01 1.95100793239E+01 1.98435839632E+01 2.01827893988E+01 2.05277930780E+01 2.08786941137E+01 2.12355933127E+01 2.15985932055E+01 2.19677980749E+01 2.23433139862E+01 2.27252488180E+01 2.31137122927E+01 2.35088160083E+01 2.39106734706E+01 2.43194001253E+01 2.47351133917E+01 2.51579326963E+01 2.55879795068E+01 2.60253773673E+01 2.64702519339E+01 2.69227310102E+01 2.73829445849E+01 2.78510248684E+01 2.83271063311E+01 2.88113257419E+01 2.93038222078E+01 2.98047372134E+01 3.03142146620E+01 3.08324009165E+01 3.13594448418E+01 3.18954978476E+01 3.24407139313E+01 3.29952497230E+01 3.35592645302E+01 3.41329203834E+01 3.47163820828E+01 3.53098172456E+01 3.59133963544E+01 3.65272928057E+01 3.71516829600E+01 3.77867461926E+01 3.84326649449E+01 3.90896247768E+01 3.97578144201E+01 4.04374258329E+01 4.11286542543E+01 4.18316982608E+01 4.25467598235E+01 4.32740443657E+01 4.40137608221E+01 4.47661216989E+01 4.55313431350E+01 4.63096449635E+01 4.71012507756E+01 4.79063879842E+01 4.87252878898E+01 4.95581857464E+01 5.04053208295E+01 5.12669365045E+01 5.21432802970E+01 5.30346039636E+01 5.39411635644E+01 5.48632195363E+01 5.58010367682E+01 5.67548846769E+01 5.77250372844E+01 5.87117732967E+01 5.97153761841E+01 6.07361342621E+01 6.17743407750E+01 6.28302939792E+01 6.39042972298E+01 6.49966590670E+01 6.61076933054E+01 6.72377191234E+01 6.83870611558E+01 6.95560495861E+01 7.07450202422E+01 7.19543146924E+01 7.31842803434E+01 7.44352705407E+01 7.57076446695E+01 7.70017682583E+01 7.83180130838E+01 7.96567572776E+01 8.10183854350E+01 8.24032887255E+01 7.00212479284E-06 7.12181634392E-06 7.24355385501E-06 7.36737229896E-06 7.49330724641E-06 7.62139487602E-06 7.75167198491E-06 7.88417599915E-06 8.01894498459E-06 8.15601765776E-06 8.29543339697E-06 8.43723225367E-06 8.58145496393E-06 8.72814296014E-06 8.87733838293E-06 9.02908409325E-06 9.18342368472E-06 9.34040149610E-06 9.50006262408E-06 9.66245293622E-06 9.82761908412E-06 9.99560851680E-06 1.01664694944E-05 1.03402511019E-05 1.05170032635E-05 1.06967767566E-05 1.08796232267E-05 1.10655952020E-05 1.12547461087E-05 1.14471302862E-05 1.16428030027E-05 1.18418204711E-05 1.20442398655E-05 1.22501193369E-05 1.24595180305E-05 1.26724961026E-05 1.28891147375E-05 1.31094361657E-05 1.33335236813E-05 1.35614416602E-05 1.37932555788E-05 1.40290320329E-05 1.42688387564E-05 1.45127446411E-05 1.47608197566E-05 1.50131353699E-05 1.52697639665E-05 1.55307792709E-05 1.57962562675E-05 1.60662712230E-05 1.63409017072E-05 1.66202266163E-05 1.69043261949E-05 1.71932820593E-05 1.74871772209E-05 1.77860961102E-05 1.80901246007E-05 1.83993500339E-05 1.87138612443E-05 1.90337485850E-05 1.93591039533E-05 1.96900208175E-05 2.00265942438E-05 2.03689209230E-05 2.07170991990E-05 2.10712290967E-05 2.14314123509E-05 2.17977524350E-05 2.21703545917E-05 2.25493258622E-05 2.29347751176E-05 2.33268130902E-05 2.37255524047E-05 2.41311076114E-05 2.45435952183E-05 2.49631337252E-05 2.53898436573E-05 2.58238476003E-05 2.62652702349E-05 2.67142383734E-05 2.71708809956E-05 2.76353292862E-05 2.81077166721E-05 2.85881788611E-05 2.90768538807E-05 2.95738821177E-05 3.00794063588E-05 3.05935718313E-05 3.11165262449E-05 3.16484198344E-05 3.21894054025E-05 3.27396383639E-05 3.32992767899E-05 3.38684814537E-05 3.44474158768E-05 3.50362463759E-05 3.56351421107E-05 3.62442751322E-05 3.68638204326E-05 3.74939559952E-05 3.81348628459E-05 3.87867251047E-05 3.94497300391E-05 4.01240681175E-05 4.08099330643E-05 4.15075219151E-05 4.22170350738E-05 4.29386763697E-05 4.36726531165E-05 4.44191761713E-05 4.51784599960E-05 4.59507227180E-05 4.67361861934E-05 4.75350760707E-05 4.83476218555E-05 4.91740569765E-05 5.00146188526E-05 5.08695489608E-05 5.17390929060E-05 5.26235004915E-05 5.35230257903E-05 5.44379272187E-05 5.53684676102E-05 5.63149142910E-05 5.72775391570E-05 5.82566187516E-05 5.92524343454E-05 6.02652720170E-05 6.12954227351E-05 6.23431824421E-05 6.34088521389E-05 6.44927379720E-05 6.55951513207E-05 6.67164088870E-05 6.78568327866E-05 6.90167506412E-05 7.01964956727E-05 7.13964067990E-05 7.26168287315E-05 7.38581120736E-05 7.51206134221E-05 7.64046954692E-05 7.77107271068E-05 7.90390835326E-05 8.03901463576E-05 8.17643037160E-05 8.31619503766E-05 8.45834878563E-05 8.60293245354E-05 8.74998757746E-05 8.89955640350E-05 9.05168189987E-05 9.20640776930E-05 9.36377846153E-05 9.52383918612E-05 9.68663592540E-05 9.85221544775E-05 1.00206253209E-04 1.01919139259E-04 1.03661304705E-04 1.05433250038E-04 1.07235484303E-04 1.09068525248E-04 1.10932899469E-04 1.12829142566E-04 1.14757799293E-04 1.16719423714E-04 1.18714579367E-04 1.20743839422E-04 1.22807786845E-04 1.24907014569E-04 1.27042125661E-04 1.29213733497E-04 1.31422461939E-04 1.33668945511E-04 1.35953829584E-04 1.38277770562E-04 1.40641436067E-04 1.43045505136E-04 1.45490668410E-04 1.47977628338E-04 1.50507099375E-04 1.53079808189E-04 1.55696493869E-04 1.58357908140E-04 1.61064815573E-04 1.63817993811E-04 1.66618233789E-04 1.69466339961E-04 1.72363130533E-04 1.75309437697E-04 1.78306107870E-04 1.81354001938E-04 1.84453995501E-04 1.87606979127E-04 1.90813858609E-04 1.94075555219E-04 1.97393005981E-04 2.00767163934E-04 2.04198998408E-04 2.07689495303E-04 2.11239657371E-04 2.14850504505E-04 2.18523074031E-04 2.22258421008E-04 2.26057618528E-04 2.29921758028E-04 2.33851949599E-04 2.37849322311E-04 2.41915024530E-04 2.46050224254E-04 2.50256109447E-04 2.54533888377E-04 2.58884789968E-04 2.63310064149E-04 2.67810982217E-04 2.72388837197E-04 2.77044944219E-04 2.81780640893E-04 2.86597287692E-04 2.91496268346E-04 2.96478990238E-04 3.01546884806E-04 3.06701407958E-04 3.11944040491E-04 3.17276288510E-04 3.22699683867E-04 3.28215784598E-04 3.33826175374E-04 3.39532467949E-04 3.45336301633E-04 3.51239343753E-04 3.57243290140E-04 3.63349865612E-04 3.69560824468E-04 3.75877950998E-04 3.82303059990E-04 3.88837997254E-04 3.95484640149E-04 4.02244898129E-04 4.09120713284E-04 4.16114060903E-04 4.23226950040E-04 4.30461424089E-04 4.37819561376E-04 4.45303475751E-04 4.52915317198E-04 4.60657272450E-04 4.68531565623E-04 4.76540458849E-04 4.84686252926E-04 4.92971287985E-04 5.01397944156E-04 5.09968642254E-04 5.18685844474E-04 5.27552055100E-04 5.36569821223E-04 5.45741733473E-04 5.55070426762E-04 5.64558581044E-04 5.74208922081E-04 5.84024222230E-04 5.94007301237E-04 6.04161027047E-04 6.14488316629E-04 6.24992136814E-04 6.35675505145E-04 6.46541490748E-04 6.57593215210E-04 6.68833853478E-04 6.80266634770E-04 6.91894843502E-04 7.03721820234E-04 7.15750962627E-04 7.27985726422E-04 7.40429626428E-04 7.53086237538E-04 7.65959195751E-04 7.79052199220E-04 7.92369009310E-04 8.05913451683E-04 8.19689417396E-04 8.33700864016E-04 8.47951816762E-04 8.62446369657E-04 8.77188686704E-04 8.92183003087E-04 9.07433626382E-04 9.22944937799E-04 9.38721393436E-04 9.54767525564E-04 9.71087943927E-04 9.87687337065E-04 1.00457047366E-03 1.02174220392E-03 1.03920746094E-03 1.05697126215E-03 1.07503871075E-03 1.09341499717E-03 1.11210540057E-03 1.13111529032E-03 1.15045012761E-03 1.17011546695E-03 1.19011695783E-03 1.21046034628E-03 1.23115147657E-03 1.25219629285E-03 1.27360084089E-03 1.29537126981E-03 1.31751383383E-03 1.34003489408E-03 1.36294092043E-03 1.38623849332E-03 1.40993430571E-03 1.43403516494E-03 1.45854799473E-03 1.48347983713E-03 1.50883785458E-03 1.53462933195E-03 1.56086167863E-03 1.58754243067E-03 1.61467925293E-03 1.64227994129E-03 1.67035242489E-03 1.69890476843E-03 1.72794517443E-03 1.75748198565E-03 1.78752368742E-03 1.81807891017E-03 1.84915643180E-03 1.88076518030E-03 1.91291423623E-03 1.94561283541E-03 1.97887037151E-03 2.01269639877E-03 2.04710063476E-03 2.08209296315E-03 2.11768343656E-03 2.15388227944E-03 2.19069989102E-03 2.22814684829E-03 2.26623390903E-03 2.30497201491E-03 2.34437229466E-03 2.38444606720E-03 2.42520484495E-03 2.46666033713E-03 2.50882445309E-03 2.55170930576E-03 2.59532721514E-03 2.63969071181E-03 2.68481254054E-03 2.73070566396E-03 2.77738326628E-03 2.82485875706E-03 2.87314577510E-03 2.92225819233E-03 2.97221011778E-03 3.02301590169E-03 3.07469013957E-03 3.12724767642E-03 3.18070361102E-03 3.23507330022E-03 3.29037236337E-03 3.34661668684E-03 3.40382242852E-03 3.46200602251E-03 3.52118418384E-03 3.58137391325E-03 3.64259250209E-03 3.70485753726E-03 3.76818690631E-03 3.83259880254E-03 3.89811173024E-03 3.96474451001E-03 4.03251628416E-03 4.10144652220E-03 4.17155502646E-03 4.24286193776E-03 4.31538774119E-03 4.38915327202E-03 4.46417972164E-03 4.54048864371E-03 4.61810196031E-03 4.69704196823E-03 4.77733134542E-03 4.85899315747E-03 4.94205086422E-03 5.02652832655E-03 5.11244981320E-03 5.19984000775E-03 5.28872401572E-03 5.37912737175E-03 5.47107604699E-03 5.56459645650E-03 5.65971546690E-03 5.75646040403E-03 5.85485906084E-03 5.95493970537E-03 6.05673108884E-03 6.16026245394E-03 6.26556354325E-03 6.37266460771E-03 6.48159641541E-03 6.59239026032E-03 6.70507797139E-03 6.81969192162E-03 6.93626503736E-03 7.05483080783E-03 7.17542329467E-03 7.29807714178E-03 7.42282758522E-03 7.54971046339E-03 7.67876222729E-03 7.81001995098E-03 7.94352134227E-03 8.07930475353E-03 8.21740919270E-03 8.35787433452E-03 8.50074053191E-03 8.64604882755E-03 8.79384096572E-03 8.94415940422E-03 9.09704732665E-03 9.25254865473E-03 9.41070806101E-03 9.57157098160E-03 9.73518362931E-03 9.90159300690E-03 1.00708469206E-02 1.02429939937E-02 1.04180836807E-02 1.05961662816E-02 1.07772929560E-02 1.09615157382E-02 1.11488875517E-02 1.13394622249E-02 1.15332945061E-02 1.17304400796E-02 1.19309555816E-02 1.21348986163E-02 1.23423277725E-02 1.25533026407E-02 1.27678838298E-02 1.29861329848E-02 1.32081128045E-02 1.34338870595E-02 1.36635206103E-02 1.38970794261E-02 1.41346306040E-02 1.43762423877E-02 1.46219841876E-02 1.48719266006E-02 1.51261414304E-02 1.53847017079E-02 1.56476817125E-02 1.59151569933E-02 1.61872043907E-02 1.64639020586E-02 1.67453294871E-02 1.70315675247E-02 1.73226984020E-02 1.76188057554E-02 1.79199746507E-02 1.82262916080E-02 1.85378446262E-02 1.88547232084E-02 1.91770183878E-02 1.95048227534E-02 1.98382304772E-02 2.01773373407E-02 2.05222407628E-02 2.08730398275E-02 2.12298353126E-02 2.15927297187E-02 2.19618272981E-02 2.23372340855E-02 2.27190579281E-02 2.31074085163E-02 2.35023974159E-02 2.39041380995E-02 2.43127459793E-02 2.47283384407E-02 2.51510348751E-02 2.55809567152E-02 2.60182274691E-02 2.64629727563E-02 2.69153203435E-02 2.73754001813E-02 2.78433444420E-02 2.83192875566E-02 2.88033662546E-02 2.92957196024E-02 2.97964890435E-02 3.03058184393E-02 3.08238541103E-02 3.13507448782E-02 3.18866421083E-02 3.24316997537E-02 3.29860743989E-02 3.35499253049E-02 3.41234144553E-02 3.47067066023E-02 3.52999693145E-02 3.59033730248E-02 3.65170910795E-02 3.71412997877E-02 3.77761784727E-02 3.84219095227E-02 3.90786784439E-02 3.97466739132E-02 4.04260878327E-02 4.11171153850E-02 4.18199550889E-02 4.25348088567E-02 4.32618820519E-02 4.40013835487E-02 4.47535257915E-02 4.55185248563E-02 4.62966005125E-02 4.70879762861E-02 4.78928795241E-02 4.87115414596E-02 4.95441972783E-02 5.03910861863E-02 5.12524514781E-02 5.21285406075E-02 5.30196052579E-02 5.39259014149E-02 5.48476894399E-02 5.57852341447E-02 5.67388048678E-02 5.77086755515E-02 5.86951248211E-02 5.96984360642E-02 6.07188975127E-02 6.17568023256E-02 6.28124486727E-02 6.38861398209E-02 6.49781842208E-02 6.60888955956E-02 6.72185930312E-02 6.83676010679E-02 6.95362497934E-02 7.07248749379E-02 7.19338179704E-02 7.31634261968E-02 7.44140528597E-02 7.56860572401E-02 7.69798047601E-02 7.82956670885E-02 7.96340222468E-02 8.09952547188E-02 8.23797555602E-02 8.37879225112E-02 8.52201601109E-02 8.66768798136E-02 8.81585001066E-02 8.96654466307E-02 9.11981523026E-02 9.27570574388E-02 9.43426098827E-02 9.59552651328E-02 9.75954864738E-02 9.92637451095E-02 1.00960520298E-01 1.02686299491E-01 1.04441578470E-01 1.06226861494E-01 1.08042661440E-01 1.09889499951E-01 1.11767907590E-01 1.13678423985E-01 1.15621597992E-01 1.17597987847E-01 1.19608161328E-01 1.21652695919E-01 1.23732178975E-01 1.25847207892E-01 1.27998390277E-01 1.30186344123E-01 1.32411697986E-01 1.34675091167E-01 1.36977173896E-01 1.39318607517E-01 1.41700064678E-01 1.44122229525E-01 1.46585797899E-01 1.49091477537E-01 1.51639988272E-01 1.54232062241E-01 1.56868444096E-01 1.59549891220E-01 1.62277173941E-01 1.65051075753E-01 1.67872393545E-01 1.70741937828E-01 1.73660532966E-01 1.76629017414E-01 1.79648243960E-01 1.82719079971E-01 1.85842407638E-01 1.89019124233E-01 1.92250142364E-01 1.95536390241E-01 1.98878811938E-01 2.02278367671E-01 2.05736034064E-01 2.09252804438E-01 2.12829689094E-01 2.16467715601E-01 2.20167929094E-01 2.23931392572E-01 2.27759187206E-01 2.31652412648E-01 2.35612187345E-01 2.39639648864E-01 2.43735954217E-01 2.47902280193E-01 2.52139823697E-01 2.56449802094E-01 2.60833453556E-01 2.65292037421E-01 2.69826834556E-01 2.74439147719E-01 2.79130301938E-01 2.83901644892E-01 2.88754547294E-01 2.93690403290E-01 2.98710630856E-01 3.03816672206E-01 3.09009994207E-01 3.14292088799E-01 3.19664473427E-01 3.25128691472E-01 3.30686312699E-01 3.36338933704E-01 3.42088178376E-01 3.47935698363E-01 3.53883173543E-01 3.59932312510E-01 3.66084853066E-01 3.72342562716E-01 3.78707239180E-01 3.85180710904E-01 3.91764837594E-01 3.98461510740E-01 4.05272654168E-01 4.12200224587E-01 4.19246212154E-01 4.26412641045E-01 4.33701570037E-01 4.41115093097E-01 4.48655339987E-01 4.56324476875E-01 4.64124706954E-01 4.72058271081E-01 4.80127448414E-01 4.88334557072E-01 4.96681954799E-01 5.05172039640E-01 5.13807250633E-01 5.22590068506E-01 5.31523016393E-01 5.40608660558E-01 5.49849611129E-01 5.59248522854E-01 5.68808095857E-01 5.78531076420E-01 5.88420257765E-01 5.98478480865E-01 6.08708635250E-01 6.19113659848E-01 6.29696543820E-01 6.40460327423E-01 6.51408102885E-01 6.62543015290E-01 6.73868263483E-01 6.85387100987E-01 6.97102836943E-01 7.09018837054E-01 7.21138524557E-01 7.33465381204E-01 7.46002948261E-01 7.58754827530E-01 7.71724682378E-01 7.84916238794E-01 7.98333286456E-01 8.11979679824E-01 8.25859339240E-01 8.39976252064E-01 8.54334473811E-01 8.68938129320E-01 8.83791413939E-01 8.98898594729E-01 9.14264011691E-01 9.29892079011E-01 9.45787286332E-01 9.61954200038E-01 9.78397464572E-01 9.95121803764E-01 1.01213202219E+00 1.02943300657E+00 1.04702972712E+00 1.06492723906E+00 1.08313068399E+00 1.10164529140E+00 1.12047638018E+00 1.13962936015E+00 1.15910973358E+00 1.17892309680E+00 1.19907514182E+00 1.21957165793E+00 1.24041853337E+00 1.26162175705E+00 1.28318742025E+00 1.30512171837E+00 1.32743095270E+00 1.35012153225E+00 1.37319997560E+00 1.39667291273E+00 -1.91202984859E+01 -1.91202984859E+01 -1.91202984469E+01 -1.91202984534E+01 -1.91202984673E+01 -1.91202984839E+01 -1.91202985042E+01 -1.91202985288E+01 -1.91202985577E+01 -1.91202985913E+01 -1.91202986298E+01 -1.91202986734E+01 -1.91202987224E+01 -1.91202987770E+01 -1.91202988375E+01 -1.91202989042E+01 -1.91202989773E+01 -1.91202990571E+01 -1.91202991440E+01 -1.91202992383E+01 -1.91202993403E+01 -1.91202994503E+01 -1.91202995687E+01 -1.91202996958E+01 -1.91202998321E+01 -1.91202999779E+01 -1.91203001337E+01 -1.91203002999E+01 -1.91203004768E+01 -1.91203006651E+01 -1.91203008651E+01 -1.91203010774E+01 -1.91203013024E+01 -1.91203015408E+01 -1.91203017930E+01 -1.91203020596E+01 -1.91203023412E+01 -1.91203026385E+01 -1.91203029521E+01 -1.91203032826E+01 -1.91203036308E+01 -1.91203039973E+01 -1.91203043829E+01 -1.91203047884E+01 -1.91203052145E+01 -1.91203056621E+01 -1.91203061320E+01 -1.91203066252E+01 -1.91203071425E+01 -1.91203076850E+01 -1.91203082535E+01 -1.91203088491E+01 -1.91203094729E+01 -1.91203101260E+01 -1.91203108096E+01 -1.91203115247E+01 -1.91203122727E+01 -1.91203130547E+01 -1.91203138722E+01 -1.91203147265E+01 -1.91203156190E+01 -1.91203165512E+01 -1.91203175245E+01 -1.91203185406E+01 -1.91203196011E+01 -1.91203207077E+01 -1.91203218621E+01 -1.91203230661E+01 -1.91203243217E+01 -1.91203256308E+01 -1.91203269953E+01 -1.91203284174E+01 -1.91203298992E+01 -1.91203314430E+01 -1.91203330511E+01 -1.91203347259E+01 -1.91203364699E+01 -1.91203382856E+01 -1.91203401757E+01 -1.91203421431E+01 -1.91203441905E+01 -1.91203463209E+01 -1.91203485375E+01 -1.91203508433E+01 -1.91203532417E+01 -1.91203557360E+01 -1.91203583298E+01 -1.91203610268E+01 -1.91203638308E+01 -1.91203667456E+01 -1.91203697753E+01 -1.91203729241E+01 -1.91203761963E+01 -1.91203795966E+01 -1.91203831294E+01 -1.91203867997E+01 -1.91203906124E+01 -1.91203945727E+01 -1.91203986860E+01 -1.91204029577E+01 -1.91204073937E+01 -1.91204119997E+01 -1.91204167821E+01 -1.91204217472E+01 -1.91204269014E+01 -1.91204322517E+01 -1.91204378050E+01 -1.91204435687E+01 -1.91204495502E+01 -1.91204557574E+01 -1.91204621985E+01 -1.91204688817E+01 -1.91204758156E+01 -1.91204830092E+01 -1.91204904719E+01 -1.91204982132E+01 -1.91205062429E+01 -1.91205145713E+01 -1.91205232090E+01 -1.91205321671E+01 -1.91205414568E+01 -1.91205510900E+01 -1.91205610786E+01 -1.91205714354E+01 -1.91205821733E+01 -1.91205933058E+01 -1.91206048467E+01 -1.91206168105E+01 -1.91206292119E+01 -1.91206420664E+01 -1.91206553900E+01 -1.91206691989E+01 -1.91206835102E+01 -1.91206983416E+01 -1.91207137112E+01 -1.91207296378E+01 -1.91207461408E+01 -1.91207632403E+01 -1.91207809571E+01 -1.91207993127E+01 -1.91208183292E+01 -1.91208380295E+01 -1.91208584375E+01 -1.91208795776E+01 -1.91209014751E+01 -1.91209241561E+01 -1.91209476477E+01 -1.91209719779E+01 -1.91209971755E+01 -1.91210232702E+01 -1.91210502931E+01 -1.91210782757E+01 -1.91211072511E+01 -1.91211372531E+01 -1.91211683168E+01 -1.91212004785E+01 -1.91212337755E+01 -1.91212682463E+01 -1.91213039308E+01 -1.91213408703E+01 -1.91213791070E+01 -1.91214186849E+01 -1.91214596492E+01 -1.91215020464E+01 -1.91215459249E+01 -1.91215913343E+01 -1.91216383257E+01 -1.91216869521E+01 -1.91217372679E+01 -1.91217893293E+01 -1.91218431944E+01 -1.91218989228E+01 -1.91219565761E+01 -1.91220162177E+01 -1.91220779131E+01 -1.91221417295E+01 -1.91222077363E+01 -1.91222760051E+01 -1.91223466094E+01 -1.91224196248E+01 -1.91224951295E+01 -1.91225732035E+01 -1.91226539295E+01 -1.91227373923E+01 -1.91228236793E+01 -1.91229128801E+01 -1.91230050872E+01 -1.91231003952E+01 -1.91231989017E+01 -1.91233007065E+01 -1.91234059123E+01 -1.91235146246E+01 -1.91236269517E+01 -1.91237430041E+01 -1.91238628959E+01 -1.91239867433E+01 -1.91241146660E+01 -1.91242467860E+01 -1.91243832287E+01 -1.91245241218E+01 -1.91246695966E+01 -1.91248197865E+01 -1.91249748285E+01 -1.91251348621E+01 -1.91253000297E+01 -1.91254704762E+01 -1.91256463498E+01 -1.91258278009E+01 -1.91260149832E+01 -1.91262080520E+01 -1.91264071657E+01 -1.91266124849E+01 -1.91268241726E+01 -1.91270423934E+01 -1.91272673142E+01 -1.91274991036E+01 -1.91277379317E+01 -1.91279839697E+01 -1.91282373904E+01 -1.91284983667E+01 -1.91287670725E+01 -1.91290436815E+01 -1.91293283677E+01 -1.91296213037E+01 -1.91299226618E+01 -1.91302326123E+01 -1.91305513237E+01 -1.91308789616E+01 -1.91312156889E+01 -1.91315616637E+01 -1.91319170407E+01 -1.91322819680E+01 -1.91326565886E+01 -1.91330410374E+01 -1.91334354422E+01 -1.91338399208E+01 -1.91342545816E+01 -1.91346795209E+01 -1.91351148232E+01 -1.91355605578E+01 -1.91360167798E+01 -1.91364835266E+01 -1.91369608172E+01 -1.91374486497E+01 -1.91379470010E+01 -1.91384558226E+01 -1.91389750410E+01 -1.91395045526E+01 -1.91400442246E+01 -1.91405938894E+01 -1.91411533448E+01 -1.91417223485E+01 -1.91423006180E+01 -1.91428878247E+01 -1.91434835935E+01 -1.91440874968E+01 -1.91446990534E+01 -1.91453177221E+01 -1.91459429013E+01 -1.91465739208E+01 -1.91472100418E+01 -1.91478504487E+01 -1.91484942482E+01 -1.91491404604E+01 -1.91497880186E+01 -1.91504357595E+01 -1.91510824225E+01 -1.91517266397E+01 -1.91523669350E+01 -1.91530017136E+01 -1.91536292613E+01 -1.91542477330E+01 -1.91548551522E+01 -1.91554493990E+01 -1.91560282101E+01 -1.91565891655E+01 -1.91571296894E+01 -1.91576470364E+01 -1.91581382920E+01 -1.91586003593E+01 -1.91590299599E+01 -1.91594236196E+01 -1.91597776704E+01 -1.91600882359E+01 -1.91603512342E+01 -1.91605623632E+01 -1.91607171042E+01 -1.91608107072E+01 -1.91608381962E+01 -1.91607943542E+01 -1.91606737301E+01 -1.91604706234E+01 -1.91601790940E+01 -1.91597929463E+01 -1.91593057407E+01 -1.91587107793E+01 -1.91580011191E+01 -1.91571695575E+01 -1.91562086493E+01 -1.91551106925E+01 -1.91538677472E+01 -1.91524716232E+01 -1.91509139016E+01 -1.91491859228E+01 -1.91472788121E+01 -1.91451834675E+01 -1.91428905892E+01 -1.91403906683E+01 -1.91376740196E+01 -1.91347307707E+01 -1.91315508984E+01 -1.91281242187E+01 -1.91244404264E+01 -1.91204890850E+01 -1.91162596703E+01 -1.91117415600E+01 -1.91069240808E+01 -1.91017964970E+01 -1.90963480612E+01 -1.90905680020E+01 -1.90844455775E+01 -1.90779700612E+01 -1.90711307987E+01 -1.90639171911E+01 -1.90563187545E+01 -1.90483250999E+01 -1.90399259954E+01 -1.90311113427E+01 -1.90218712406E+01 -1.90121959572E+01 -1.90020759955E+01 -1.89915020601E+01 -1.89804651243E+01 -1.89689563904E+01 -1.89569673585E+01 -1.89444897794E+01 -1.89315157245E+01 -1.89180375308E+01 -1.89040478719E+01 -1.88895396933E+01 -1.88745062843E+01 -1.88589412034E+01 -1.88428383500E+01 -1.88261918782E+01 -1.88089962690E+01 -1.87912462304E+01 -1.87729367690E+01 -1.87540630755E+01 -1.87346205943E+01 -1.87146048928E+01 -1.86940117281E+01 -1.86728368970E+01 -1.86510762995E+01 -1.86287257673E+01 -1.86057811218E+01 -1.85822379792E+01 -1.85580918029E+01 -1.85333376812E+01 -1.85079703743E+01 -1.84819840634E+01 -1.84553723922E+01 -1.84281281865E+01 -1.84002434919E+01 -1.83717092657E+01 -1.83425154138E+01 -1.83126504586E+01 -1.82821015815E+01 -1.82508542724E+01 -1.82188923886E+01 -1.81861977944E+01 -1.81527504485E+01 -1.81185280465E+01 -1.80835061529E+01 -1.80476578588E+01 -1.80109539756E+01 -1.79733627224E+01 -1.79348499953E+01 -1.78953790959E+01 -1.78549110877E+01 -1.78134045681E+01 -1.77708161151E+01 -1.77271000975E+01 -1.76822092023E+01 -1.76360942637E+01 -1.75887048513E+01 -1.75399890843E+01 -1.74898942464E+01 -1.74383665432E+01 -1.73853517016E+01 -1.73307946205E+01 -1.72746399124E+01 -1.72168313996E+01 -1.71573125638E+01 -1.70960258530E+01 -1.70329130242E+01 -1.69679142526E+01 -1.69009683884E+01 -1.68320119051E+01 -1.67609791475E+01 -1.66878012226E+01 -1.66124063974E+01 -1.65347191244E+01 -1.64546608442E+01 -1.63721494296E+01 -1.62871007268E+01 -1.61994287551E+01 -1.61090483236E+01 -1.60158762630E+01 -1.59198353167E+01 -1.58208564498E+01 -1.57188838843E+01 -1.56138781100E+01 -1.55058214250E+01 -1.53947206980E+01 -1.52806121353E+01 -1.51635621649E+01 -1.50436694305E+01 -1.49210614583E+01 -1.47958912371E+01 -1.46683269371E+01 -1.45385405680E+01 -1.44066891721E+01 -1.42728958381E+01 -1.41372259278E+01 -1.39996686394E+01 -1.38601222487E+01 -1.37183955685E+01 -1.35742242778E+01 -1.34273109127E+01 -1.32773786711E+01 -1.31242347983E+01 -1.29678206448E+01 -1.28082364794E+01 -1.26457228034E+01 -1.24806047772E+01 -1.23132096805E+01 -1.21437910791E+01 -1.19724824126E+01 -1.17993047724E+01 -1.16242182146E+01 -1.14471959360E+01 -1.12682694709E+01 -1.10875149105E+01 -1.09049573929E+01 -1.07204308205E+01 -1.05336058329E+01 -1.03448966880E+01 -1.01562565863E+01 -9.96897054259E+00 -9.78279740418E+00 -9.59804426701E+00 -9.41533985773E+00 -9.23519718798E+00 -9.05815242186E+00 -8.88476679723E+00 -8.71563566604E+00 -8.55139624954E+00 -8.39273636330E+00 -8.24040088458E+00 -8.09519993733E+00 -7.95796669383E+00 -7.82433238322E+00 -7.69304231999E+00 -7.56402991313E+00 -7.43722859011E+00 -7.31257131174E+00 -7.19000748486E+00 -7.06949418710E+00 -6.95098437756E+00 -6.83444908248E+00 -6.71985494982E+00 -6.60716147898E+00 -6.49633727634E+00 -6.38735107721E+00 -6.28017282444E+00 -6.17477347073E+00 -6.07112469995E+00 -5.96919886997E+00 -5.86896883159E+00 -5.77040791120E+00 -5.67348979819E+00 -5.57818855051E+00 -5.48447852762E+00 -5.39233440693E+00 -5.30173114570E+00 -5.21264400084E+00 -5.12504850838E+00 -5.03892050238E+00 -4.95423610448E+00 -4.87097173994E+00 -4.78910413257E+00 -4.70861031713E+00 -4.62946763693E+00 -4.55165375253E+00 -4.47514664031E+00 -4.39992459804E+00 -4.32596624344E+00 -4.25325051713E+00 -4.18175668078E+00 -4.11146431797E+00 -4.04235333181E+00 -3.97440394418E+00 -3.90759669280E+00 -3.84191242924E+00 -3.77733231560E+00 -3.71383782156E+00 -3.65141072070E+00 -3.59003308700E+00 -3.52968729085E+00 -3.47035599513E+00 -3.41202215109E+00 -3.35466899417E+00 -3.29828003971E+00 -3.24283907878E+00 -3.18833017378E+00 -3.13473765418E+00 -3.08204611224E+00 -3.03024039874E+00 -2.97930561872E+00 -2.92922712734E+00 -2.87999052567E+00 -2.83158165666E+00 -2.78398660106E+00 -2.73719167350E+00 -2.69118341852E+00 -2.64594860679E+00 -2.60147423130E+00 -2.55774750365E+00 -2.51475585043E+00 -2.47248690963E+00 -2.43092852713E+00 -2.39006875321E+00 -2.34989583922E+00 -2.31039823420E+00 -2.27156458158E+00 -2.23338371602E+00 -2.19584466015E+00 -2.15893662149E+00 -2.12264898938E+00 -2.08697133188E+00 -2.05189339284E+00 -2.01740508894E+00 -1.98349650676E+00 -1.95015789990E+00 -1.91737968620E+00 -1.88515244493E+00 -1.85346691403E+00 -1.82231398742E+00 -1.79168471235E+00 -1.76157028674E+00 -1.73196205663E+00 -1.70285151364E+00 -1.67423029247E+00 -1.64609016845E+00 -1.61842305516E+00 -1.59122100202E+00 -1.56447619204E+00 -1.53818093952E+00 -1.51232768783E+00 -1.48690900722E+00 -1.46191759271E+00 -1.43734626195E+00 -1.41318795323E+00 -1.38943572339E+00 -1.36608274587E+00 -1.34312230880E+00 -1.32054781301E+00 -1.29835277021E+00 -1.27653080115E+00 -1.25507563374E+00 -1.23398110133E+00 -1.21324114092E+00 -1.19284979143E+00 -1.17280119201E+00 -1.15308958036E+00 -1.13370929106E+00 -1.11465475398E+00 -1.09592049267E+00 -1.07750112277E+00 -1.05939135050E+00 -1.04158597112E+00 -1.02407986740E+00 -1.00686800823E+00 -9.89945447090E-01 -9.73307320662E-01 -9.56948847435E-01 -9.40865326316E-01 -9.25052135277E-01 -9.09504730027E-01 -8.94218642700E-01 -8.79189480571E-01 -8.64412924784E-01 -8.49884729118E-01 -8.35600718751E-01 -8.21556789070E-01 -8.07748904480E-01 -7.94173097244E-01 -7.80825466345E-01 -7.67702176355E-01 -7.54799456337E-01 -7.42113598756E-01 -7.29640958413E-01 -7.17377951397E-01 -7.05321054051E-01 -6.93466801960E-01 -6.81811788954E-01 -6.70352666125E-01 -6.59086140869E-01 -6.48008975935E-01 -6.37117988493E-01 -6.26410049221E-01 -6.15882081404E-01 -6.05531060050E-01 -5.95354011016E-01 -5.85348010159E-01 -5.75510182490E-01 -5.65837701254E-01 -5.56327787517E-01 -5.46977708760E-01 -5.37784778480E-01 -5.28746355338E-01 -5.19859842393E-01 -5.11122686358E-01 -5.02532376867E-01 -4.94086445749E-01 -4.85782466326E-01 -4.77618052706E-01 -4.69590859106E-01 -4.61698579170E-01 -4.53938945311E-01 -4.46309728059E-01 -4.38808735416E-01 -4.31433812231E-01 -4.24182839578E-01 -4.17053734145E-01 -4.10044447639E-01 -4.03152966197E-01 -3.96377309804E-01 -3.89715531727E-01 -3.83165717953E-01 -3.76725986642E-01 -3.70394487583E-01 -3.64169401665E-01 -3.58048940353E-01 -3.52031345173E-01 -3.46114887209E-01 -3.40297866604E-01 -3.34578612074E-01 -3.28955480423E-01 -3.23426856078E-01 -3.17991150617E-01 -3.12646802321E-01 -3.07392275652E-01 -3.02226061920E-01 -2.97146674940E-01 -2.92152656380E-01 -2.87242571424E-01 -2.82415009373E-01 -2.77668583239E-01 -2.73001929348E-01 -2.68413706946E-01 -2.63902597814E-01 -2.59467305892E-01 -2.55106556903E-01 -2.50819097988E-01 -2.46603697346E-01 -2.42459143881E-01 -2.38384246854E-01 -2.34377835536E-01 -2.30438758881E-01 -2.26565885186E-01 -2.22758101769E-01 -2.19014314654E-01 -2.15333448248E-01 -2.11714445039E-01 -2.08156265288E-01 -2.04657886733E-01 -2.01218304293E-01 -1.97836529780E-01 -1.94511591615E-01 -1.91242534552E-01 -1.88028419395E-01 -1.84868322739E-01 -1.81761336695E-01 -1.78706568637E-01 -1.75703140939E-01 -1.72750190728E-01 -1.69846869632E-01 -1.66992343539E-01 -1.64185792357E-01 -1.61426409775E-01 -1.58713403037E-01 -1.56045992709E-01 -1.53423412459E-01 -1.50844908835E-01 -1.48309741047E-01 -1.45817180756E-01 -1.43366511867E-01 -1.40957030316E-01 -1.38588043878E-01 -1.36258871957E-01 -1.33968845400E-01 -1.31717306299E-01 -1.29503607803E-01 -1.27327113934E-01 -1.25187199403E-01 -1.23083249429E-01 -1.21014659565E-01 -1.18980835524E-01 -1.16981193003E-01 -1.15015157526E-01 -1.13082164266E-01 -1.11181657892E-01 -1.09313092408E-01 -1.07475930992E-01 -1.05669645845E-01 -1.03893718040E-01 -1.02147637370E-01 -1.00430902204E-01 -9.87430193412E-02 -9.70835038715E-02 1 0 Beta L 491 0.00000000000E+00 -3.34272979846E-05 -6.74244996297E-05 -1.02006270230E-04 -1.37176092461E-04 -1.72948247451E-04 -2.09330179534E-04 -2.46338737058E-04 -2.83974261597E-04 -3.22256422226E-04 -3.61192297128E-04 -4.00792277627E-04 -4.41072172971E-04 -4.82038123426E-04 -5.23705417369E-04 -5.66082793344E-04 -6.09190790282E-04 -6.53025269059E-04 -6.97619352325E-04 -7.42970087259E-04 -7.89097291269E-04 -8.36012484582E-04 -8.83731566035E-04 -9.32262912895E-04 -9.81627149013E-04 -1.03183455116E-03 -1.08289823534E-03 -1.13483780255E-03 -1.18766118162E-03 -1.24138949331E-03 -1.29603949038E-03 -1.35161885895E-03 -1.40814900865E-03 -1.46564799198E-03 -1.52412845739E-03 -1.58360853647E-03 -1.64410427411E-03 -1.70563498148E-03 -1.76821954841E-03 -1.83186973202E-03 -1.89661162581E-03 -1.96245646862E-03 -2.02943381346E-03 -2.09754566066E-03 -2.16683039207E-03 -2.23729550365E-03 -2.30896756097E-03 -2.38186081032E-03 -2.45600448037E-03 -2.53141237937E-03 -2.60811063609E-03 -2.68611956065E-03 -2.76546133062E-03 -2.84616299610E-03 -2.92823731644E-03 -3.01172079167E-03 -3.09662698128E-03 -3.18298884162E-03 -3.27082246896E-03 -3.36015979135E-03 -3.45102460175E-03 -3.54344111545E-03 -3.63743864799E-03 -3.73304272342E-03 -3.83027755118E-03 -3.92918193226E-03 -4.02976855633E-03 -4.13208088551E-03 -4.23613770175E-03 -4.34197637858E-03 -4.44962282005E-03 -4.55910913218E-03 -4.67046518748E-03 -4.78372908363E-03 -4.89892433709E-03 -5.01609355626E-03 -5.13525849280E-03 -5.25646921356E-03 -5.37974257025E-03 -5.50513065954E-03 -5.63265802721E-03 -5.76236594630E-03 -5.89429059177E-03 -6.02847020625E-03 -6.16494603417E-03 -6.30374963140E-03 -6.44493033384E-03 -6.58852075263E-03 -6.73456829340E-03 -6.88310980929E-03 -7.03419259328E-03 -7.18785561077E-03 -7.34414583619E-03 -7.50310908258E-03 -7.66478573253E-03 -7.82922945402E-03 -7.99648155714E-03 -8.16659450263E-03 -8.33961194380E-03 -8.51559087698E-03 -8.69457227852E-03 -8.87661735676E-03 -9.06177221432E-03 -9.25009187215E-03 -9.44162924383E-03 -9.63644179584E-03 -9.83458370885E-03 -1.00361116966E-02 -1.02410838020E-02 -1.04495601522E-02 -1.06615986785E-02 -1.08772615556E-02 -1.10966111349E-02 -1.13197083209E-02 -1.15466190677E-02 -1.17774081304E-02 -1.20121406995E-02 -1.22508851576E-02 -1.24937109335E-02 -1.27406864035E-02 -1.29918815428E-02 -1.32473709306E-02 -1.35072245458E-02 -1.37715238590E-02 -1.40403332428E-02 -1.43137416728E-02 -1.45918203293E-02 -1.48746519588E-02 -1.51623159662E-02 -1.54548963903E-02 -1.57524772564E-02 -1.60551412562E-02 -1.63629811979E-02 -1.66760773993E-02 -1.69945253115E-02 -1.73184163270E-02 -1.76478398885E-02 -1.79828925836E-02 -1.83236716384E-02 -1.86702729067E-02 -1.90227958897E-02 -1.93813423822E-02 -1.97460168239E-02 -2.01169187947E-02 -2.04941603744E-02 -2.08778470401E-02 -2.12680874816E-02 -2.16649973316E-02 -2.20686852588E-02 -2.24792726715E-02 -2.28968723500E-02 -2.33216077576E-02 -2.37535970740E-02 -2.41929676370E-02 -2.46398419779E-02 -2.50943516486E-02 -2.55566229482E-02 -2.60267916689E-02 -2.65049904648E-02 -2.69913573999E-02 -2.74860305166E-02 -2.79891529318E-02 -2.85008678777E-02 -2.90213206578E-02 -2.95506632874E-02 -3.00890438668E-02 -3.06366190394E-02 -3.11935434071E-02 -3.17599780674E-02 -3.23360837089E-02 -3.29220261473E-02 -3.35179716364E-02 -3.41240914703E-02 -3.47405589214E-02 -3.53675497194E-02 -3.60052422016E-02 -3.66538214605E-02 -3.73134686834E-02 -3.79843755765E-02 -3.86667317128E-02 -3.93607326611E-02 -4.00665759656E-02 -4.07844643843E-02 -4.15146000136E-02 -4.22571929653E-02 -4.30124553856E-02 -4.37806007604E-02 -4.45618491996E-02 -4.53564225094E-02 -4.61645473729E-02 -4.69864540902E-02 -4.78223750908E-02 -4.86725500148E-02 -4.95372192844E-02 -5.04166295850E-02 -5.13110296561E-02 -5.22206749692E-02 -5.31458223136E-02 -5.40867353822E-02 -5.50436802031E-02 -5.60169293883E-02 -5.70067570438E-02 -5.80134450412E-02 -5.90372774723E-02 -6.00785444408E-02 -6.11375411230E-02 -6.22145653614E-02 -6.33099230062E-02 -6.44239221240E-02 -6.55568779776E-02 -6.67091098026E-02 -6.78809421996E-02 -6.90727047529E-02 -7.02847347009E-02 -7.15173703778E-02 -7.27709598569E-02 -7.40458555448E-02 -7.53424131817E-02 -7.66609984787E-02 -7.80019795058E-02 -7.93657320343E-02 -8.07526373042E-02 -8.21630825031E-02 -8.35974618879E-02 -8.50561747420E-02 -8.65396277965E-02 -8.80482330622E-02 -8.95824107592E-02 -9.11425859629E-02 -9.27291911972E-02 -9.43426662432E-02 -9.59834571691E-02 -9.76520160553E-02 -9.93488048281E-02 -1.01074289024E-01 -1.02828944207E-01 -1.04613251384E-01 -1.06427700105E-01 -1.08272786360E-01 -1.10149014439E-01 -1.12056896142E-01 -1.13996950218E-01 -1.15969703994E-01 -1.17975692369E-01 -1.20015457731E-01 -1.22089551292E-01 -1.24198531068E-01 -1.26342964506E-01 -1.28523426284E-01 -1.30740499633E-01 -1.32994775782E-01 -1.35286855693E-01 -1.37617345571E-01 -1.39986864178E-01 -1.42396035112E-01 -1.44845492838E-01 -1.47335879403E-01 -1.49867845432E-01 -1.52442050784E-01 -1.55059162854E-01 -1.57719859129E-01 -1.60424824467E-01 -1.63174752938E-01 -1.65970347647E-01 -1.68812319367E-01 -1.71701388613E-01 -1.74638283440E-01 -1.77623741201E-01 -1.80658507507E-01 -1.83743336346E-01 -1.86878990165E-01 -1.90066239443E-01 -1.93305863352E-01 -1.96598648863E-01 -1.99945390818E-01 -2.03346891809E-01 -2.06803962643E-01 -2.10317421272E-01 -2.13888092495E-01 -2.17516809621E-01 -2.21204411169E-01 -2.24951743673E-01 -2.28759659427E-01 -2.32629017124E-01 -2.36560680825E-01 -2.40555521021E-01 -2.44614412327E-01 -2.48738234668E-01 -2.52927872634E-01 -2.57184213867E-01 -2.61508150426E-01 -2.65900576737E-01 -2.70362389936E-01 -2.74894489069E-01 -2.79497774358E-01 -2.84173146792E-01 -2.88921507338E-01 -2.93743756342E-01 -2.98640792460E-01 -3.03613512380E-01 -3.08662809626E-01 -3.13789573638E-01 -3.18994688954E-01 -3.24279034616E-01 -3.29643482229E-01 -3.35088895948E-01 -3.40616130188E-01 -3.46226029824E-01 -3.51919427584E-01 -3.57697143613E-01 -3.63559983924E-01 -3.69508738614E-01 -3.75544181162E-01 -3.81667065754E-01 -3.87878127003E-01 -3.94178077197E-01 -4.00567604881E-01 -4.07047373608E-01 -4.13618019144E-01 -4.20280148285E-01 -4.27034336385E-01 -4.33881125767E-01 -4.40821023144E-01 -4.47854497657E-01 -4.54981978675E-01 -4.62203853413E-01 -4.69520464657E-01 -4.76932108194E-01 -4.84439030683E-01 -4.92041426994E-01 -4.99739437201E-01 -5.07533145252E-01 -5.15422575104E-01 -5.23407688879E-01 -5.31488383992E-01 -5.39664490741E-01 -5.47935769540E-01 -5.56301908553E-01 -5.64762521141E-01 -5.73317143114E-01 -5.81965231148E-01 -5.90706159417E-01 -5.99539218559E-01 -6.08463612647E-01 -6.17478458002E-01 -6.26582781251E-01 -6.35775517696E-01 -6.45055510387E-01 -6.54421508811E-01 -6.63872168325E-01 -6.73406049964E-01 -6.83021620043E-01 -6.92717250982E-01 -7.02491221913E-01 -7.12341719902E-01 -7.22266842122E-01 -7.32264598013E-01 -7.42332912212E-01 -7.52469628424E-01 -7.62672513661E-01 -7.72939263166E-01 -7.83267506393E-01 -7.93654813589E-01 -8.04098703060E-01 -8.14596649788E-01 -8.25146094124E-01 -8.35744452289E-01 -8.46389127057E-01 -8.57077519413E-01 -8.67807041637E-01 -8.78575130213E-01 -8.89379260479E-01 -9.00216961291E-01 -9.11085830391E-01 -9.21983550378E-01 -9.32907904891E-01 -9.43856794356E-01 -9.54828252413E-01 -9.65820460919E-01 -9.76831764635E-01 -9.87860684473E-01 -9.98905928772E-01 -1.00996640264E+00 -1.02104121388E+00 -1.03212967524E+00 -1.04323130281E+00 -1.05434580765E+00 -1.06547308224E+00 -1.07661317833E+00 -1.08776627623E+00 -1.09893264378E+00 -1.11011258316E+00 -1.12130636439E+00 -1.13251414336E+00 -1.14373586255E+00 -1.15497113258E+00 -1.16621909223E+00 -1.17747824464E+00 -1.18874626810E+00 -1.20001979806E+00 -1.21129417905E+00 -1.22256318410E+00 -1.23381869935E+00 -1.24505037254E+00 -1.25624522392E+00 -1.26738721853E+00 -1.27845680001E+00 -1.28943038601E+00 -1.30027982765E+00 -1.31097183496E+00 -1.32146737389E+00 -1.33172104007E+00 -1.34168041896E+00 -1.35128544240E+00 -1.36046775648E+00 -1.36915011751E+00 -1.37724583775E+00 -1.38465830601E+00 -1.39128061394E+00 -1.39699532276E+00 -1.40167441179E+00 -1.40517945500E+00 -1.40736207847E+00 -1.40806475628E+00 -1.40712200895E+00 -1.40436207219E+00 -1.39960910735E+00 -1.39268602639E+00 -1.38341800332E+00 -1.37163673837E+00 -1.35718553280E+00 -1.33992521514E+00 -1.31974093772E+00 -1.29654982764E+00 -1.27030943268E+00 -1.24102684294E+00 -1.20876829377E+00 -1.17366896086E+00 -1.13594254255E+00 -1.09589008476E+00 -1.05390734092E+00 -1.01048977127E+00 -9.66234077637E-01 -9.21834946089E-01 -8.78075443231E-01 -8.35809300283E-01 -7.95933152120E-01 -7.59346720235E-01 -7.26899000982E-01 -6.99318835777E-01 -6.77128922672E-01 -6.60543554991E-01 -6.49352381581E-01 -6.42795598863E-01 -6.39440645995E-01 -6.37077265613E-01 -6.32657493151E-01 -6.22320783874E-01 -6.01563436680E-01 -5.65637539155E-01 -5.10279028304E-01 -4.30590777917E-01 -3.26681048675E-01 -2.06008581123E-01 -8.71071469368E-02 -9.66876317564E-03 8.43168813569E-04 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2 0 Beta L 491 0.00000000000E+00 5.18020389289E-05 1.04500053457E-04 1.58079777245E-04 2.12585184773E-04 2.68028573533E-04 3.24419995871E-04 3.81755584419E-04 4.40085007829E-04 4.99424008248E-04 5.59763369062E-04 6.21132732644E-04 6.83539289982E-04 7.47043727725E-04 8.11611517503E-04 8.77312931047E-04 9.44041015881E-04 1.01207902450E-03 1.08112390692E-03 1.15140858364E-03 1.22291617899E-03 1.29561696929E-03 1.36955453100E-03 1.44479011976E-03 1.52128265463E-03 1.59906627118E-03 1.67824229781E-03 1.75868857978E-03 1.84059909784E-03 1.92387226403E-03 2.00850323295E-03 2.09467740178E-03 2.18230468198E-03 2.27139600513E-03 2.36199753051E-03 2.45420126892E-03 2.54796674139E-03 2.64331641998E-03 2.74028453517E-03 2.83895735834E-03 2.93927519697E-03 3.04133983595E-03 3.14506256821E-03 3.25073783050E-03 3.35801661149E-03 3.46728193925E-03 3.57829316919E-03 3.69132041298E-03 3.80618508302E-03 3.92306075902E-03 4.04193693310E-03 4.16281471356E-03 4.28580301182E-03 4.41079510366E-03 4.53807965755E-03 4.66741346593E-03 4.79901633536E-03 4.93283265836E-03 5.06896558437E-03 5.20742545324E-03 5.34822663005E-03 5.49146880731E-03 5.63710999923E-03 5.78528554148E-03 5.93602571833E-03 6.08920946389E-03 6.24518641043E-03 6.40368129345E-03 6.56497859106E-03 6.72898784008E-03 6.89580673287E-03 7.06548117545E-03 7.23809923595E-03 7.41358013791E-03 7.59214209137E-03 7.77366180190E-03 7.95844416432E-03 8.14617454934E-03 8.33731711575E-03 8.53157622158E-03 8.72922887572E-03 8.93024564879E-03 9.13470575884E-03 9.34265879184E-03 9.55412029698E-03 9.76927632248E-03 9.98804847923E-03 1.02106045138E-02 1.04369090161E-02 1.06671456878E-02 1.09012539049E-02 1.11394236358E-02 1.13816303980E-02 1.16279577967E-02 1.18785611484E-02 1.21333846403E-02 1.23925944092E-02 1.26562115150E-02 1.29243753047E-02 1.31970589099E-02 1.34744930658E-02 1.37565836463E-02 1.40435372070E-02 1.43353866722E-02 1.46322371326E-02 1.49341470903E-02 1.52412080278E-02 1.55535328189E-02 1.58712079033E-02 1.61942800014E-02 1.65229118397E-02 1.68571267755E-02 1.71970572246E-02 1.75428238623E-02 1.78944757959E-02 1.82521488512E-02 1.86159373098E-02 1.89859410580E-02 1.93622638252E-02 1.97450031530E-02 2.01343189013E-02 2.05302652886E-02 2.09330048013E-02 2.13425569137E-02 2.17592128443E-02 2.21829071774E-02 2.26138716912E-02 2.30522003671E-02 2.34980244264E-02 2.39514674788E-02 2.44126394548E-02 2.48817408297E-02 2.53587823017E-02 2.58440446738E-02 2.63375913033E-02 2.68395237756E-02 2.73500829753E-02 2.78693597835E-02 2.83974869548E-02 2.89346495136E-02 2.94810086521E-02 3.00366905647E-02 3.06018424794E-02 3.11767076083E-02 3.17613518618E-02 3.23559829775E-02 3.29608171138E-02 3.35759253523E-02 3.42016142751E-02 3.48379271767E-02 3.54851618612E-02 3.61434072401E-02 3.68129565965E-02 3.74938892961E-02 3.81865002089E-02 3.88909009285E-02 3.96073808214E-02 4.03360676016E-02 4.10772160286E-02 4.18310207249E-02 4.25977092759E-02 4.33774855287E-02 4.41705835411E-02 4.49772419814E-02 4.57976554416E-02 4.66321043199E-02 4.74807870762E-02 4.83439810047E-02 4.92219077067E-02 5.01148323627E-02 5.10229929503E-02 5.19466835924E-02 5.28861367256E-02 5.38416286412E-02 5.48134384030E-02 5.58018576623E-02 5.68071205420E-02 5.78295797632E-02 5.88694706495E-02 5.99271322408E-02 6.10028382048E-02 6.20969168542E-02 6.32096508861E-02 6.43414014170E-02 6.54924663412E-02 6.66631581017E-02 6.78538431392E-02 6.90648444909E-02 7.02965121660E-02 7.15491948672E-02 7.28232401428E-02 7.41190474886E-02 7.54369344428E-02 7.67773171344E-02 7.81405545359E-02 7.95270539170E-02 8.09371863060E-02 8.23713780524E-02 8.38300196727E-02 8.53135370912E-02 8.68223323330E-02 8.83568671685E-02 8.99175437270E-02 9.15048317644E-02 9.31191688802E-02 9.47610027617E-02 9.64308282629E-02 9.81290875376E-02 9.98562892409E-02 1.01612900549E-01 1.03399426930E-01 1.05216378307E-01 1.07064271241E-01 1.08943600237E-01 1.10854940991E-01 1.12798802063E-01 1.14775727060E-01 1.16786306450E-01 1.18831070669E-01 1.20910617508E-01 1.23025521632E-01 1.25176383970E-01 1.27363808167E-01 1.29588401756E-01 1.31850796976E-01 1.34151619907E-01 1.36491528730E-01 1.38871158006E-01 1.41291186338E-01 1.43752291479E-01 1.46255149349E-01 1.48800460208E-01 1.51388947894E-01 1.54021302609E-01 1.56698286585E-01 1.59420617150E-01 1.62189066247E-01 1.65004384943E-01 1.67867366361E-01 1.70778791029E-01 1.73739454598E-01 1.76750188915E-01 1.79811807090E-01 1.82925150438E-01 1.86091078161E-01 1.89310441760E-01 1.92584140134E-01 1.95913040320E-01 1.99298062170E-01 2.02740121704E-01 2.06240151371E-01 2.09799076384E-01 2.13417893043E-01 2.17097534462E-01 2.20839014809E-01 2.24643320893E-01 2.28511467351E-01 2.32444490075E-01 2.36443419280E-01 2.40509329200E-01 2.44643273682E-01 2.48846347503E-01 2.53119654590E-01 2.57464295812E-01 2.61881415657E-01 2.66372146637E-01 2.70937650185E-01 2.75579102840E-01 2.80297682120E-01 2.85094598317E-01 2.89971057029E-01 2.94928299193E-01 2.99967558583E-01 3.05090093938E-01 3.10297176458E-01 3.15590096016E-01 3.20970142142E-01 3.26438625385E-01 3.31996880360E-01 3.37646224002E-01 3.43388021288E-01 3.49223621547E-01 3.55154397359E-01 3.61181730034E-01 3.67307014017E-01 3.73531645533E-01 3.79857034949E-01 3.86284607930E-01 3.92815778386E-01 3.99451990726E-01 4.06194676335E-01 4.13045280655E-01 4.20005253699E-01 4.27076041953E-01 4.34259099910E-01 4.41555879919E-01 4.48967833072E-01 4.56496406737E-01 4.64143048806E-01 4.71909195598E-01 4.79796278187E-01 4.87805719151E-01 4.95938930026E-01 5.04197301306E-01 5.12582216144E-01 5.21095031756E-01 5.29737087882E-01 5.38509695773E-01 5.47414140051E-01 5.56451674153E-01 5.65623513244E-01 5.74930838969E-01 5.84374780217E-01 5.93956430350E-01 6.03676816539E-01 6.13536916231E-01 6.23537644700E-01 6.33679839114E-01 6.43964270657E-01 6.54391622160E-01 6.64962491188E-01 6.75677374036E-01 6.86536666058E-01 6.97540646360E-01 7.08689474359E-01 7.19983172221E-01 7.31421624097E-01 7.43004558199E-01 7.54731535111E-01 7.66601937187E-01 7.78614963085E-01 7.90769591917E-01 8.03064591694E-01 8.15498489732E-01 8.28069559822E-01 8.40775801987E-01 8.53614925799E-01 8.66584327168E-01 8.79681066143E-01 8.92901852000E-01 9.06243000592E-01 9.19700432214E-01 9.33269619118E-01 9.46945578108E-01 9.60722824684E-01 9.74595343239E-01 9.88556560583E-01 1.00259929497E+00 1.01671572940E+00 1.03089736540E+00 1.04513497672E+00 1.05941857047E+00 1.07373733266E+00 1.08807957909E+00 1.10243270583E+00 1.11678312648E+00 1.13111621578E+00 1.14541625184E+00 1.15966634554E+00 1.17384837445E+00 1.18794291555E+00 1.20192916778E+00 1.21578487642E+00 1.22948625673E+00 1.24300790640E+00 1.25632272718E+00 1.26940183298E+00 1.28221446040E+00 1.29472788349E+00 1.30690730967E+00 1.31871579734E+00 1.33011415203E+00 1.34106083343E+00 1.35151186420E+00 1.36142073244E+00 1.37073829900E+00 1.37941271796E+00 1.38738934268E+00 1.39461065608E+00 1.40101619913E+00 1.40654250799E+00 1.41112307023E+00 1.41468828405E+00 1.41716544389E+00 1.41847874177E+00 1.41854928229E+00 1.41729514298E+00 1.41463144242E+00 1.41047045748E+00 1.40472177372E+00 1.39729247623E+00 1.38808739529E+00 1.37700940109E+00 1.36395976205E+00 1.34883856885E+00 1.33154523104E+00 1.31197905613E+00 1.29003991849E+00 1.26562901488E+00 1.23864973465E+00 1.20900863207E+00 1.17661651543E+00 1.14138966470E+00 1.10325117417E+00 1.06213242933E+00 1.01797472513E+00 9.70731014882E-01 9.20367809342E-01 8.66867196502E-01 8.10229002743E-01 7.50473059226E-01 6.87641578208E-01 6.21801601004E-01 5.53047503354E-01 4.81503510265E-01 4.07326184833E-01 3.30706829156E-01 2.51873740075E-01 1.71094232224E-01 8.86763495575E-02 4.97015035399E-03 -7.96315408924E-02 -1.64693060159E-01 -2.49736640861E-01 -3.34244133874E-01 -4.17659872779E-01 -4.99394866203E-01 -5.78832495970E-01 -6.55335908423E-01 -7.28257255025E-01 -7.96948942981E-01 -8.60776991237E-01 -9.19136565197E-01 -9.71469660599E-01 -1.01728482767E+00 -1.05617868716E+00 -1.08785882657E+00 -1.11216746408E+00 -1.12910502126E+00 -1.13885244712E+00 -1.14179081247E+00 -1.13851630117E+00 -1.12984832811E+00 -1.11682807576E+00 -1.10070434467E+00 -1.08290324958E+00 -1.06497807707E+00 -1.04853561764E+00 -1.03513564152E+00 -1.02616110274E+00 -1.02265836957E+00 -1.02514966379E+00 -1.03342439834E+00 -1.04632286353E+00 -1.06153554120E+00 -1.07545530306E+00 -1.08313923055E+00 -1.07846364284E+00 -1.05459233444E+00 -1.00492712301E+00 -9.24610416468E-01 -7.94094461343E-01 -6.10558964657E-01 -3.88808244246E-01 -1.65522917565E-01 -1.85274665660E-02 1.64193203022E-03 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 3 1 Beta L 491 0.00000000000E+00 -5.21801323189E-10 7.11914611862E-09 3.80290813882E-09 4.11285917538E-10 -4.18689615521E-09 -9.93878296996E-09 -1.69163640736E-08 -2.51720847035E-08 -3.47696806945E-08 -4.57834613713E-08 -5.82634731025E-08 -7.22869249944E-08 -8.79382808255E-08 -1.05267718471E-07 -1.24373197829E-07 -1.45334964341E-07 -1.68220132144E-07 -1.93134376306E-07 -2.20171238610E-07 -2.49393081684E-07 -2.80930800262E-07 -3.14894633320E-07 -3.51334827223E-07 -3.90428300936E-07 -4.32245902739E-07 -4.76917649575E-07 -5.24566599258E-07 -5.75316452401E-07 -6.29302963653E-07 -6.86677009495E-07 -7.47538076886E-07 -8.12086015827E-07 -8.80436599119E-07 -9.52773670682E-07 -1.02921697161E-06 -1.11002563936E-06 -1.19526614936E-06 -1.28520886412E-06 -1.38000683939E-06 -1.47985190896E-06 -1.58498069354E-06 -1.69556755363E-06 -1.81188344000E-06 -1.93406977511E-06 -2.06244548803E-06 -2.19728057362E-06 -2.33869360066E-06 -2.48709596998E-06 -2.64265834509E-06 -2.80573623573E-06 -2.97659139183E-06 -3.15548957114E-06 -3.34289877651E-06 -3.53886340683E-06 -3.74408838462E-06 -3.95857592899E-06 -4.18294464523E-06 -4.41744769230E-06 -4.66248672995E-06 -4.91853176335E-06 -5.18592515793E-06 -5.46514510267E-06 -5.75669005501E-06 -6.06085791553E-06 -6.37835379312E-06 -6.70953183172E-06 -7.05498084224E-06 -7.41521027777E-06 -7.79079149300E-06 -8.18222418843E-06 -8.59034248071E-06 -9.01550675670E-06 -9.45840978690E-06 -9.91988391497E-06 -1.04004645995E-05 -1.09008997774E-05 -1.14219288857E-05 -1.19643932723E-05 -1.25289528508E-05 -1.31165588727E-05 -1.37279814900E-05 -1.43641340392E-05 -1.50260173019E-05 -1.57143487172E-05 -1.64303709212E-05 -1.71749054353E-05 -1.79491816898E-05 -1.87540710009E-05 -1.95908778146E-05 -2.04607652671E-05 -2.13647908301E-05 -2.23044123257E-05 -2.32807950093E-05 -2.42952444763E-05 -2.53493231321E-05 -2.64443240640E-05 -2.75817735380E-05 -2.87632366356E-05 -2.99902677640E-05 -3.12646817340E-05 -3.25879392425E-05 -3.39619477693E-05 -3.53886315326E-05 -3.68697218224E-05 -3.84073382621E-05 -4.00033395016E-05 -4.16600803975E-05 -4.33795089839E-05 -4.51639913963E-05 -4.70159765247E-05 -4.89376488186E-05 -5.09317724540E-05 -5.30006276340E-05 -5.51473089451E-05 -5.73742581043E-05 -5.96845703378E-05 -6.20810168867E-05 -6.45669423671E-05 -6.71453215718E-05 -6.98196318573E-05 -7.25930158142E-05 -7.54695752563E-05 -7.84523115300E-05 -8.15453560947E-05 -8.47527763252E-05 -8.80783804907E-05 -9.15263837332E-05 -9.51013259802E-05 -9.88077231231E-05 -1.02649924839E-04 -1.06633129874E-04 -1.10762067942E-04 -1.15042221432E-04 -1.19478502772E-04 -1.24076936933E-04 -1.28842851826E-04 -1.33782548483E-04 -1.38901708966E-04 -1.44207292052E-04 -1.49705370250E-04 -1.55402794085E-04 -1.61307073043E-04 -1.67425046834E-04 -1.73764292916E-04 -1.80332812004E-04 -1.87138627117E-04 -1.94190025262E-04 -2.01495700399E-04 -2.09064769821E-04 -2.16906209049E-04 -2.25029771575E-04 -2.33445447066E-04 -2.42163384100E-04 -2.51194326282E-04 -2.60549201711E-04 -2.70239317082E-04 -2.80276730391E-04 -2.90673267383E-04 -3.01441728339E-04 -3.12595399422E-04 -3.24147166519E-04 -3.36111777607E-04 -3.48503042164E-04 -3.61336297337E-04 -3.74626875978E-04 -3.88390820092E-04 -4.02644881626E-04 -4.17405862071E-04 -4.32691958083E-04 -4.48521001481E-04 -4.64912641819E-04 -4.81885957454E-04 -4.99461682660E-04 -5.17660601116E-04 -5.36504833925E-04 -5.56016532121E-04 -5.76219283532E-04 -5.97137240694E-04 -6.18795200807E-04 -6.41219105455E-04 -6.64435667354E-04 -6.88472648019E-04 -7.13358447076E-04 -7.39122954994E-04 -7.65796435644E-04 -7.93411131202E-04 -8.21999421392E-04 -8.51595160018E-04 -8.82234026439E-04 -9.13951561483E-04 -9.46786376262E-04 -9.80776139781E-04 -1.01596209386E-03 -1.05238547968E-03 -1.09008935554E-03 -1.12911831979E-03 -1.16951854733E-03 -1.21133760379E-03 -1.25462524253E-03 -1.29943170630E-03 -1.34581100699E-03 -1.39381672464E-03 -1.44350611730E-03 -1.49493725961E-03 -1.54817106249E-03 -1.60326988765E-03 -1.66029881973E-03 -1.71932444055E-03 -1.78041660559E-03 -1.84364700907E-03 -1.90908951672E-03 -1.97682130657E-03 -2.04692189130E-03 -2.11947312731E-03 -2.19456041589E-03 -2.27227180096E-03 -2.35269801705E-03 -2.43593341109E-03 -2.52207565518E-03 -2.61122514072E-03 -2.70348675977E-03 -2.79896755183E-03 -2.89778030299E-03 -3.00003947024E-03 -3.10586522268E-03 -3.21538063361E-03 -3.32871427777E-03 -3.44599775747E-03 -3.56736845499E-03 -3.69296778301E-03 -3.82294202370E-03 -3.95744340423E-03 -4.09662782309E-03 -4.24065809593E-03 -4.38970198300E-03 -4.54393275377E-03 -4.70353029648E-03 -4.86868033883E-03 -5.03957482375E-03 -5.21641312040E-03 -5.39940038150E-03 -5.58874958926E-03 -5.78468098738E-03 -5.98742233817E-03 -6.19720871267E-03 -6.41428454202E-03 -6.63890147427E-03 -6.87132030586E-03 -7.11181114834E-03 -7.36065269098E-03 -7.61813400935E-03 -7.88455354979E-03 -8.16022024512E-03 -8.44545401051E-03 -8.74058483723E-03 -9.04595555793E-03 -9.36191928883E-03 -9.68884220315E-03 -1.00271030450E-02 -1.03770931516E-02 -1.07392177095E-02 -1.11138958280E-02 -1.15015608394E-02 -1.19026611114E-02 -1.23176604980E-02 -1.27470385240E-02 -1.31912917726E-02 -1.36509330220E-02 -1.41264938175E-02 -1.46185227030E-02 -1.51275879727E-02 -1.56542773904E-02 -1.61991983455E-02 -1.67629793181E-02 -1.73462710107E-02 -1.79497452041E-02 -1.85740977812E-02 -1.92200479287E-02 -1.98883399468E-02 -2.05797428719E-02 -2.12950528405E-02 -2.20350929254E-02 -2.28007142694E-02 -2.35927972135E-02 -2.44122525400E-02 -2.52600212216E-02 -2.61370775567E-02 -2.70444282662E-02 -2.79831144954E-02 -2.89542134214E-02 -2.99588383801E-02 -3.09981403733E-02 -3.20733106110E-02 -3.31855801474E-02 -3.43362209931E-02 -3.55265506250E-02 -3.67579280938E-02 -3.80317617755E-02 -3.93495050355E-02 -4.07126618751E-02 -4.21227869359E-02 -4.35814863032E-02 -4.50904215731E-02 -4.66513091901E-02 -4.82659240408E-02 -4.99360996041E-02 -5.16637317954E-02 -5.34507793693E-02 -5.52992665105E-02 -5.72112846562E-02 -5.91889955514E-02 -6.12346315694E-02 -6.33504998082E-02 -6.55389834246E-02 -6.78025434750E-02 -7.01437226618E-02 -7.25651466724E-02 -7.50695266236E-02 -7.76596621133E-02 -8.03384439561E-02 -8.31088553035E-02 -8.59739766001E-02 -8.89369860714E-02 -9.20011633608E-02 -9.51698931175E-02 -9.84466656534E-02 -1.01835082009E-01 -1.05338854778E-01 -1.08961812617E-01 -1.12707901007E-01 -1.16581187607E-01 -1.20585862184E-01 -1.24726241827E-01 -1.29006771124E-01 -1.33432027471E-01 -1.38006720694E-01 -1.42735698125E-01 -1.47623944730E-01 -1.52676586330E-01 -1.57898891074E-01 -1.63296272132E-01 -1.68874287529E-01 -1.74638642753E-01 -1.80595191700E-01 -1.86749936161E-01 -1.93109027125E-01 -1.99678764914E-01 -2.06465596312E-01 -2.13476116964E-01 -2.20717065591E-01 -2.28195325138E-01 -2.35917916802E-01 -2.43891998511E-01 -2.52124856905E-01 -2.60623905652E-01 -2.69396674332E-01 -2.78450803865E-01 -2.87794034433E-01 -2.97434196969E-01 -3.07379198901E-01 -3.17637012145E-01 -3.28215656317E-01 -3.39123180854E-01 -3.50367646755E-01 -3.61957103143E-01 -3.73899563964E-01 -3.86202980775E-01 -3.98875213156E-01 -4.11923995974E-01 -4.25356904205E-01 -4.39181313283E-01 -4.53404357384E-01 -4.68032882309E-01 -4.83073396524E-01 -4.98532015767E-01 -5.14414406256E-01 -5.30725719710E-01 -5.47470528811E-01 -5.64652752561E-01 -5.82275581101E-01 -6.00341393508E-01 -6.18851671198E-01 -6.37806906300E-01 -6.57206506151E-01 -6.77048690731E-01 -6.97330388419E-01 -7.18047125086E-01 -7.39192910425E-01 -7.60760120254E-01 -7.82739375424E-01 -8.05119419306E-01 -8.27886992208E-01 -8.51026705134E-01 -8.74520915488E-01 -8.98349600411E-01 -9.22490235547E-01 -9.46917677035E-01 -9.71604046512E-01 -9.96518626483E-01 -1.02162776012E+00 -1.04689476515E+00 -1.07227985607E+00 -1.09774008250E+00 -1.12322928035E+00 -1.14869804264E+00 -1.17409370371E+00 -1.19936034613E+00 -1.22443882410E+00 -1.24926680562E+00 -1.27377883297E+00 -1.29790639787E+00 -1.32157802986E+00 -1.34471939163E+00 -1.36725337636E+00 -1.38910020199E+00 -1.41017748445E+00 -1.43040029101E+00 -1.44968114805E+00 -1.46792999438E+00 -1.48505406221E+00 -1.50095766115E+00 -1.51554185377E+00 -1.52870399006E+00 -1.54033709398E+00 -1.55032906905E+00 -1.55856172341E+00 -1.56490959447E+00 -1.56923858261E+00 -1.57140440725E+00 -1.57125091822E+00 -1.56860832039E+00 -1.56329139982E+00 -1.55509787275E+00 -1.54380702551E+00 -1.52917886671E+00 -1.51095406087E+00 -1.48885499310E+00 -1.46258835954E+00 -1.43184976671E+00 -1.39633085603E+00 -1.35572953870E+00 -1.30976391312E+00 -1.25819043333E+00 -1.20082678519E+00 -1.13757975379E+00 -1.06847807582E+00 -9.93709806516E-01 -9.13663124339E-01 -8.28968653769E-01 -7.40540338337E-01 -6.49610631138E-01 -5.57754419955E-01 -4.66894684664E-01 -3.79281930958E-01 -2.97439244349E-01 -2.24066434636E-01 -1.61901518733E-01 -1.13548006339E-01 -8.12953347477E-02 -6.68757155233E-02 -5.80320680676E-02 -4.85236246062E-02 -3.52330988089E-02 -1.74872081391E-02 -2.35981376662E-03 2.14317888382E-04 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 4 1 Beta L 491 0.00000000000E+00 -1.08480537791E-09 -7.65219151095E-09 -1.10200573623E-08 -1.65125457416E-08 -2.36960834852E-08 -3.27081554003E-08 -4.36327502323E-08 -5.65655312325E-08 -7.16003026830E-08 -8.88425122417E-08 -1.08393695316E-07 -1.30361648817E-07 -1.54865065176E-07 -1.82014265200E-07 -2.11938317980E-07 -2.44760342051E-07 -2.80612456694E-07 -3.19630994917E-07 -3.61964709037E-07 -4.07747508095E-07 -4.57145724712E-07 -5.10317854498E-07 -5.67416936508E-07 -6.28629844854E-07 -6.94125599599E-07 -7.64091381038E-07 -8.38719263584E-07 -9.18208320891E-07 -1.00276467350E-06 -1.09260756851E-06 -1.18794805936E-06 -1.28903193659E-06 -1.39608582085E-06 -1.50937142625E-06 -1.62912581499E-06 -1.75564755457E-06 -1.88918264687E-06 -2.03003700499E-06 -2.17850830278E-06 -2.33489619399E-06 -2.49953695269E-06 -2.67274637038E-06 -2.85488766265E-06 -3.04630125625E-06 -3.24736289317E-06 -3.45848409047E-06 -3.68001455600E-06 -3.91241345137E-06 -4.15607894832E-06 -4.41147283190E-06 -4.67905774460E-06 -4.95928678356E-06 -5.25270885652E-06 -5.55975004786E-06 -5.88104769930E-06 -6.21706100203E-06 -6.56841854674E-06 -6.93569736579E-06 -7.31949327962E-06 -7.72047251294E-06 -8.13927208673E-06 -8.57658633642E-06 -9.03312356725E-06 -9.50959546015E-06 -1.00067949200E-05 -1.05254850421E-05 -1.10664997335E-05 -1.16306704753E-05 -1.22188711053E-05 -1.28320036271E-05 -1.34710519047E-05 -1.41369380822E-05 -1.48306625987E-05 -1.55533332321E-05 -1.63059775446E-05 -1.70897285330E-05 -1.79057525179E-05 -1.87552627701E-05 -1.96394681592E-05 -2.05597041070E-05 -2.15172645608E-05 -2.25135639330E-05 -2.35500433741E-05 -2.46281161270E-05 -2.57494218452E-05 -2.69154546205E-05 -2.81279533736E-05 -2.93885320738E-05 -3.06990259947E-05 -3.20612517316E-05 -3.34770721863E-05 -3.49484924430E-05 -3.64775223028E-05 -3.80662459632E-05 -3.97168824187E-05 -4.14316661623E-05 -4.32129203590E-05 -4.50630789841E-05 -4.69846302632E-05 -4.89802075959E-05 -5.10524329683E-05 -5.32041062238E-05 -5.54381319609E-05 -5.77574508249E-05 -6.01651641833E-05 -6.26644377071E-05 -6.52586252784E-05 -6.79510780813E-05 -7.07453794247E-05 -7.36452004009E-05 -7.66543006384E-05 -7.97766371609E-05 -8.30162192743E-05 -8.63773402301E-05 -8.98642743950E-05 -9.34815913130E-05 -9.72338845600E-05 -1.01126058377E-04 -1.05163053579E-04 -1.09350091747E-04 -1.13692437667E-04 -1.18195802500E-04 -1.22865716567E-04 -1.27708244869E-04 -1.32729526530E-04 -1.37935879668E-04 -1.43333864538E-04 -1.48930369889E-04 -1.54732410509E-04 -1.60747233336E-04 -1.66982454904E-04 -1.73445827893E-04 -1.80145538325E-04 -1.87089800681E-04 -1.94287428780E-04 -2.01747259771E-04 -2.09478679828E-04 -2.17491143665E-04 -2.25794751214E-04 -2.34399647189E-04 -2.43316460004E-04 -2.52556330096E-04 -2.62130520344E-04 -2.72050807999E-04 -2.82329451522E-04 -2.92979026628E-04 -3.04012586075E-04 -3.15443630963E-04 -3.27286179599E-04 -3.39554612808E-04 -3.52263938518E-04 -3.65429625641E-04 -3.79067698626E-04 -3.93194714730E-04 -4.07827814328E-04 -4.22984715130E-04 -4.38683831934E-04 -4.54944069347E-04 -4.71785082456E-04 -4.89227295393E-04 -5.07291533101E-04 -5.25999744515E-04 -5.45374303367E-04 -5.65438507233E-04 -5.86216459221E-04 -6.07733022714E-04 -6.30014049617E-04 -6.53086059545E-04 -6.76976771287E-04 -7.01714552869E-04 -7.27329068488E-04 -7.53850676827E-04 -7.81311072904E-04 -8.09742787183E-04 -8.39179714017E-04 -8.69656651945E-04 -9.01209829053E-04 -9.33876580635E-04 -9.67695526088E-04 -1.00270665961E-03 -1.03895130669E-03 -1.07647223935E-03 -1.11531364300E-03 -1.15552126732E-03 -1.19714231820E-03 -1.24022585024E-03 -1.28482228580E-03 -1.33098391372E-03 -1.37876493609E-03 -1.42822106040E-03 -1.47941033961E-03 -1.53239227018E-03 -1.58722886564E-03 -1.64398394199E-03 -1.70272354737E-03 -1.76351599461E-03 -1.82643190723E-03 -1.89154422479E-03 -1.95892853422E-03 -2.02866259417E-03 -2.10082736003E-03 -2.17550589787E-03 -2.25278450916E-03 -2.33275214416E-03 -2.41550090298E-03 -2.50112584482E-03 -2.58972530809E-03 -2.68140076606E-03 -2.77625729240E-03 -2.87440334225E-03 -2.97595086657E-03 -3.08101579315E-03 -3.18971770405E-03 -3.30218014523E-03 -3.41853087843E-03 -3.53890178736E-03 -3.66342905595E-03 -3.79225342192E-03 -3.92552028922E-03 -4.06337965859E-03 -4.20598665093E-03 -4.35350114414E-03 -4.50608866216E-03 -4.66391958886E-03 -4.82717025783E-03 -4.99602237072E-03 -5.17066381802E-03 -5.35128815488E-03 -5.53809546962E-03 -5.73129201621E-03 -5.93109066050E-03 -6.13771127778E-03 -6.35138017056E-03 -6.57233132191E-03 -6.80080578646E-03 -7.03705213689E-03 -7.28132685222E-03 -7.53389426046E-03 -7.79502682317E-03 -8.06500560510E-03 -8.34411996846E-03 -8.63266831075E-03 -8.93095803749E-03 -9.23930583125E-03 -9.55803770584E-03 -9.88748968809E-03 -1.02280075873E-02 -1.05799473028E-02 -1.09436753915E-02 -1.13195687925E-02 -1.17080155300E-02 -1.21094145687E-02 -1.25241761959E-02 -1.29527223944E-02 -1.33954865853E-02 -1.38529145580E-02 -1.43254638751E-02 -1.48136046936E-02 -1.53178196923E-02 -1.58386041737E-02 -1.63764664574E-02 -1.69319278751E-02 -1.75055229494E-02 -1.80977995031E-02 -1.87093188308E-02 -1.93406557351E-02 -1.99923986018E-02 -2.06651493600E-02 -2.13595237925E-02 -2.20761510172E-02 -2.28156739048E-02 -2.35787488785E-02 -2.43660454948E-02 -2.51782466345E-02 -2.60160482690E-02 -2.68801587944E-02 -2.77712992296E-02 -2.86902024790E-02 -2.96376130572E-02 -3.06142863753E-02 -3.16209883464E-02 -3.26584946449E-02 -3.37275897459E-02 -3.48290662988E-02 -3.59637240298E-02 -3.71323685383E-02 -3.83358102794E-02 -3.95748630384E-02 -4.08503424421E-02 -4.21630644895E-02 -4.35138434417E-02 -4.49034898705E-02 -4.63328088951E-02 -4.78025972138E-02 -4.93136405253E-02 -5.08667114881E-02 -5.24625651981E-02 -5.41019375160E-02 -5.57855398425E-02 -5.75140562957E-02 -5.92881389468E-02 -6.11084030989E-02 -6.29754228045E-02 -6.48897249510E-02 -6.68517839120E-02 -6.88620150209E-02 -7.09207681013E-02 -7.30283202841E-02 -7.51848682381E-02 -7.73905199026E-02 -7.96452860651E-02 -8.19490703156E-02 -8.43016595963E-02 -8.67027132179E-02 -8.91517512525E-02 -9.16481427886E-02 -9.41910926920E-02 -9.67796277766E-02 -9.94125824230E-02 -1.02088583065E-01 -1.04806031416E-01 -1.07563087644E-01 -1.10357651541E-01 -1.13187343180E-01 -1.16049482961E-01 -1.18941069139E-01 -1.21858756105E-01 -1.24798829848E-01 -1.27757183493E-01 -1.30729290599E-01 -1.33710178469E-01 -1.36694398861E-01 -1.39675998884E-01 -1.42648489389E-01 -1.45604813597E-01 -1.48537313028E-01 -1.51437693913E-01 -1.54296991241E-01 -1.57105532642E-01 -1.59852901133E-01 -1.62527897328E-01 -1.65118500496E-01 -1.67611829833E-01 -1.69994105159E-01 -1.72250607505E-01 -1.74365639993E-01 -1.76322489738E-01 -1.78103389435E-01 -1.79689481970E-01 -1.81060784772E-01 -1.82196158374E-01 -1.83073275997E-01 -1.83668598147E-01 -1.83957349693E-01 -1.83913503926E-01 -1.83509770158E-01 -1.82717590200E-01 -1.81507140997E-01 -1.79847347598E-01 -1.77705905293E-01 -1.75049314584E-01 -1.71842928375E-01 -1.68051014487E-01 -1.63636835055E-01 -1.58562743977E-01 -1.52790305186E-01 -1.46280434064E-01 -1.38993563347E-01 -1.30889837179E-01 -1.21929335122E-01 -1.12072328965E-01 -1.01279575561E-01 -8.95126477364E-02 -7.67343073960E-02 -6.29089224368E-02 -4.80029319906E-02 -3.19853610492E-02 -1.48283897066E-02 3.49202319517E-03 2.29954569426E-02 4.36962861610E-02 6.56028759274E-02 8.87167140955E-02 1.13031479954E-01 1.38532051393E-01 1.65193449788E-01 1.92979728151E-01 2.21842805221E-01 2.51721252579E-01 2.82539043150E-01 3.14204271223E-01 3.46607858349E-01 3.79622261089E-01 4.13100200336E-01 4.46873437504E-01 4.80751624370E-01 5.14521260158E-01 5.47944795091E-01 5.80759922135E-01 6.12679109375E-01 6.43389426421E-01 6.72552729979E-01 6.99806275930E-01 7.24763835100E-01 7.47017393876E-01 7.66139529000E-01 7.81686548146E-01 7.93202494282E-01 8.00224112165E-01 8.02286875355E-01 7.98932169306E-01 7.89715718062E-01 7.74217330972E-01 7.52052027159E-01 7.22882569962E-01 6.86433412896E-01 6.42506009478E-01 5.90995390549E-01 5.31907839506E-01 4.65379413831E-01 3.91694963458E-01 3.11307174435E-01 2.24855035625E-01 1.33180963568E-01 3.73456539053E-02 -6.13604723704E-02 -1.61410556971E-01 -2.61040875352E-01 -3.58258449999E-01 -4.50858666695E-01 -5.36455027037E-01 -6.12523291653E-01 -6.76462307737E-01 -7.25673738185E-01 -7.57662668727E-01 -7.70160603383E-01 -7.61271611254E-01 -7.29641258296E-01 -6.74646380767E-01 -5.96601604820E-01 -4.96975712622E-01 -3.78607370868E-01 -2.45905317420E-01 -1.05012774082E-01 3.60903372686E-02 1.67580719479E-01 2.77921248664E-01 3.54174564500E-01 3.82554462277E-01 3.49271972224E-01 2.41730867116E-01 5.01162312322E-02 -2.30605665536E-01 -5.98305392179E-01 -1.04103585492E+00 -1.53434355354E+00 -2.03898229219E+00 -2.49976372515E+00 -2.84671673109E+00 -3.00036117967E+00 -2.88381536949E+00 -2.44521120838E+00 -1.69775121703E+00 -7.80420356342E-01 -9.41253104196E-02 8.27019561351E-03 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 6 Number of nonzero Dij 1 1 -1.44287863738E+00 1 2 6.75961063738E+00 2 2 -7.47140686829E+00 3 3 3.37063844420E+01 3 4 -2.71058446308E+01 4 4 2.15532715262E+01 8 nqf. If not zero, Qij's inside rinner are computed using qfcoef's 1 8.00000000000E-01 2 8.00000000000E-01 3 8.00000000000E-01 1 1 0 i j (l(j)) -6.12079541214E-01 Q_int 0.00000000000E+00 -8.77530684533E-10 -3.57037979182E-09 -8.17165154226E-09 -1.47781819071E-08 -2.34906761917E-08 -3.44138515151E-08 -4.76565843572E-08 -6.33320633501E-08 -8.15579474992E-08 -1.02456530021E-07 -1.26154907998E-07 -1.52785158047E-07 -1.82484518223E-07 -2.15395576365E-07 -2.51666465111E-07 -2.91451063822E-07 -3.34909207649E-07 -3.82206903999E-07 -4.33516556644E-07 -4.89017197767E-07 -5.48894728186E-07 -6.13342166076E-07 -6.82559904461E-07 -7.56755977794E-07 -8.36146337937E-07 -9.20955139869E-07 -1.01141503747E-06 -1.10776748971E-06 -1.21026307763E-06 -1.31916183249E-06 -1.43473357543E-06 -1.55725826913E-06 -1.68702638176E-06 -1.82433926384E-06 -1.96950953819E-06 -2.12286150372E-06 -2.28473155332E-06 -2.45546860642E-06 -2.63543455678E-06 -2.82500473592E-06 -3.02456839289E-06 -3.23452919076E-06 -3.45530572061E-06 -3.68733203344E-06 -3.93105819083E-06 -4.18695083472E-06 -4.45549377733E-06 -4.73718861154E-06 -5.03255534282E-06 -5.34213304308E-06 -5.66648052752E-06 -6.00617705511E-06 -6.36182305355E-06 -6.73404086954E-06 -7.12347554534E-06 -7.53079562237E-06 -7.95669397295E-06 -8.40188866102E-06 -8.86712383297E-06 -9.35317063949E-06 -9.86082818965E-06 -1.03909245383E-05 -1.09443177076E-05 -1.15218967448E-05 -1.21245828162E-05 -1.27533303398E-05 -1.34091281569E-05 -1.40930007452E-05 -1.48060094733E-05 -1.55492538999E-05 -1.63238731174E-05 -1.71310471423E-05 -1.79719983550E-05 -1.88479929886E-05 -1.97603426698E-05 -2.07104060137E-05 -2.16995902741E-05 -2.27293530508E-05 -2.38012040562E-05 -2.49167069444E-05 -2.60774812022E-05 -2.72852041075E-05 -2.85416127545E-05 -2.98485061500E-05 -3.12077473822E-05 -3.26212658650E-05 -3.40910596603E-05 -3.56191978805E-05 -3.72078231753E-05 -3.88591543037E-05 -4.05754887964E-05 -4.23592057100E-05 -4.42127684765E-05 -4.61387278525E-05 -4.81397249701E-05 -5.02184944937E-05 -5.23778678867E-05 -5.46207767909E-05 -5.69502565235E-05 -5.93694496952E-05 -6.18816099538E-05 -6.44901058574E-05 -6.71984248822E-05 -7.00101775684E-05 -7.29291018111E-05 -7.59590672984E-05 -7.91040801040E-05 -8.23682874390E-05 -8.57559825678E-05 -8.92716098948E-05 -9.29197702263E-05 -9.67052262157E-05 -1.00632907996E-04 -1.04707919009E-04 -1.08935542035E-04 -1.13321245428E-04 -1.17870689575E-04 -1.22589733571E-04 -1.27484442127E-04 -1.32561092719E-04 -1.37826182981E-04 -1.43286438358E-04 -1.48948820018E-04 -1.54820533041E-04 -1.60909034893E-04 -1.67222044187E-04 -1.73767549753E-04 -1.80553820017E-04 -1.87589412705E-04 -1.94883184885E-04 -2.02444303349E-04 -2.10282255365E-04 -2.18406859789E-04 -2.26828278564E-04 -2.35557028619E-04 -2.44603994180E-04 -2.53980439495E-04 -2.63698022012E-04 -2.73768806003E-04 -2.84205276661E-04 -2.95020354682E-04 -3.06227411350E-04 -3.17840284145E-04 -3.29873292884E-04 -3.42341256424E-04 -3.55259509934E-04 -3.68643922771E-04 -3.82510916961E-04 -3.96877486329E-04 -4.11761216277E-04 -4.27180304249E-04 -4.43153580898E-04 -4.59700531987E-04 -4.76841321034E-04 -4.94596812745E-04 -5.12988597251E-04 -5.32039015174E-04 -5.51771183565E-04 -5.72209022719E-04 -5.93377283929E-04 -6.15301578179E-04 -6.38008405834E-04 -6.61525187342E-04 -6.85880294992E-04 -7.11103085769E-04 -7.37223935327E-04 -7.64274273136E-04 -7.92286618827E-04 -8.21294619795E-04 -8.51333090076E-04 -8.82438050572E-04 -9.14646770643E-04 -9.47997811131E-04 -9.82531068854E-04 -1.01828782262E-03 -1.05531078083E-03 -1.09364413070E-03 -1.13333358913E-03 -1.17442645540E-03 -1.21697166560E-03 -1.26101984890E-03 -1.30662338582E-03 -1.35383646842E-03 -1.40271516256E-03 -1.45331747233E-03 -1.50570340658E-03 -1.55993504783E-03 -1.61607662343E-03 -1.67419457919E-03 -1.73435765553E-03 -1.79663696616E-03 -1.86110607951E-03 -1.92784110284E-03 -1.99692076926E-03 -2.06842652773E-03 -2.14244263602E-03 -2.21905625688E-03 -2.29835755749E-03 -2.38043981219E-03 -2.46539950874E-03 -2.55333645819E-03 -2.64435390841E-03 -2.73855866142E-03 -2.83606119480E-03 -2.93697578703E-03 -3.04142064716E-03 -3.14951804877E-03 -3.26139446846E-03 -3.37718072898E-03 -3.49701214715E-03 -3.62102868669E-03 -3.74937511624E-03 -3.88220117258E-03 -4.01966172933E-03 -4.16191697124E-03 -4.30913257431E-03 -4.46147989186E-03 -4.61913614680E-03 -4.78228463020E-03 -4.95111490654E-03 -5.12582302561E-03 -5.30661174147E-03 -5.49369073862E-03 -5.68727686551E-03 -5.88759437582E-03 -6.09487517756E-03 -6.30935909029E-03 -6.53129411080E-03 -6.76093668736E-03 -6.99855200287E-03 -7.24441426721E-03 -7.49880701902E-03 -7.76202343715E-03 -8.03436666221E-03 -8.31615012831E-03 -8.60769790551E-03 -8.90934505305E-03 -9.22143798394E-03 -9.54433484096E-03 -9.87840588464E-03 -1.02240338933E-02 -1.05816145757E-02 -1.09515569967E-02 -1.13342840158E-02 -1.17302327397E-02 -1.21398549884E-02 -1.25636177757E-02 -1.30020038048E-02 -1.34555119784E-02 -1.39246579242E-02 -1.44099745370E-02 -1.49120125360E-02 -1.54313410391E-02 -1.59685481547E-02 -1.65242415897E-02 -1.70990492763E-02 -1.76936200165E-02 -1.83086241449E-02 -1.89447542110E-02 -1.96027256800E-02 -2.02832776541E-02 -2.09871736130E-02 -2.17152021755E-02 -2.24681778812E-02 -2.32469419935E-02 -2.40523633244E-02 -2.48853390798E-02 -2.57467957284E-02 -2.66376898912E-02 -2.75590092545E-02 -2.85117735050E-02 -2.94970352885E-02 -3.05158811904E-02 -3.15694327404E-02 -3.26588474395E-02 -3.37853198111E-02 -3.49500824743E-02 -3.61544072406E-02 -3.73996062339E-02 -3.86870330325E-02 -4.00180838341E-02 -4.13941986418E-02 -4.28168624733E-02 -4.42876065892E-02 -4.58080097427E-02 -4.73796994488E-02 -4.90043532717E-02 -5.06837001298E-02 -5.24195216172E-02 -5.42136533404E-02 -5.60679862681E-02 -5.79844680932E-02 -5.99651046045E-02 -6.20119610661E-02 -6.41271636025E-02 -6.63129005867E-02 -6.85714240281E-02 -7.09050509570E-02 -7.33161648036E-02 -7.58072167654E-02 -7.83807271616E-02 -8.10392867673E-02 -8.37855581249E-02 -8.66222768261E-02 -8.95522527589E-02 -9.25783713140E-02 -9.57035945426E-02 -9.89309622602E-02 -1.02263593086E-01 -1.05704685411E-01 -1.09257518287E-01 -1.12925452222E-01 -1.16711929876E-01 -1.20620476645E-01 -1.24654701117E-01 -1.28818295392E-01 -1.33115035247E-01 -1.37548780139E-01 -1.42123473019E-01 -1.46843139944E-01 -1.51711889476E-01 -1.56733911838E-01 -1.61913477806E-01 -1.67254937327E-01 -1.72762717825E-01 -1.78441322177E-01 -1.84295326333E-01 -1.90329376545E-01 -1.96548186183E-01 -2.02956532106E-01 -2.09559250539E-01 -2.16361232446E-01 -2.23367418341E-01 -2.30582792502E-01 -2.38012376557E-01 -2.45661222380E-01 -2.53534404269E-01 -2.61637010344E-01 -2.69974133126E-01 -2.78550859231E-01 -2.87372258143E-01 -2.96443369982E-01 -3.05769192237E-01 -3.15354665380E-01 -3.25204657303E-01 -3.35323946520E-01 -3.45717204050E-01 -3.56388973925E-01 -3.67343652244E-01 -3.78585464699E-01 -3.90118442494E-01 -4.01946396595E-01 -4.14072890217E-01 -4.26501209472E-01 -4.39234332117E-01 -4.52274894302E-01 -4.65625155256E-01 -4.79286959828E-01 -4.93261698818E-01 -5.07550267019E-01 -5.22153018911E-01 -5.37069721946E-01 -5.52299507364E-01 -5.67840818494E-01 -5.83691356512E-01 -5.99848023610E-01 -6.16306863574E-01 -6.33062999759E-01 -6.50110570484E-01 -6.67442661871E-01 -6.85051238177E-01 -7.02927069714E-01 -7.21059658428E-01 -7.39437161301E-01 -7.58046311712E-01 -7.76872338979E-01 -7.95898886309E-01 -8.15107927448E-01 -8.34479682365E-01 -8.53992532364E-01 -8.73622935059E-01 -8.93345339747E-01 -9.13132103744E-01 -9.32953410359E-01 -9.52777189243E-01 -9.72569039954E-01 -9.92292159666E-01 -1.01190727606E+00 -1.03137258654E+00 -1.05064370505E+00 -1.06967361787E+00 -1.08841264991E+00 -1.10680844319E+00 -1.12480594928E+00 -1.14234743765E+00 -1.15937252207E+00 -1.17581820733E+00 -1.19161895853E+00 -1.20670679579E+00 -1.22101141674E+00 -1.23446034996E+00 -1.24697914194E+00 -1.25849158092E+00 -1.26891996043E+00 -1.27818538569E+00 -1.28620812598E+00 -1.29290801561E+00 -1.29820490655E+00 -1.30201917471E+00 -1.30427228204E+00 -1.30488739567E+00 -1.30379006460E+00 -1.30090895357E+00 -1.29617663234E+00 -1.28953041722E+00 -1.28091326002E+00 -1.27027467724E+00 -1.25757171013E+00 -1.24276990349E+00 -1.22584428814E+00 -1.20678034856E+00 -1.18557495433E+00 -1.16223723030E+00 -1.13678933777E+00 -1.10926713669E+00 -1.07972069743E+00 -1.04821463137E+00 -1.01482821246E+00 -9.79655267718E-01 -9.42803825497E-01 -9.04395525747E-01 -8.64564818973E-01 -8.23458009965E-01 -7.81232239476E-01 -7.38054540789E-01 -6.94101155922E-01 -6.49557341849E-01 -6.04617929570E-01 -5.59488898396E-01 -5.14390162800E-01 -4.69559588891E-01 -4.25257883732E-01 -3.81773314632E-01 -3.39424039362E-01 -2.98553900082E-01 -2.59514470189E-01 -2.22622727634E-01 -1.88106148898E-01 -1.56156445871E-01 -1.26954137059E-01 -1.00664181984E-01 -7.74272315143E-02 -5.73478464284E-02 -4.04797757646E-02 -2.68089691344E-02 -1.62358326273E-02 -8.55933090980E-03 -3.46683021549E-03 -5.34891368526E-04 7.52824636853E-04 9.64520125049E-04 6.52649386060E-04 2.63625353053E-04 4.48234154262E-05 3.55502295654E-07 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 -1.75967027627E+01 8.32606525088E+01 -1.84817426119E+02 3.02280052682E+02 -4.85134665376E+02 6.64185225664E+02 -5.54765747797E+02 1.95483750537E+02 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1 2 0 i j (l(j)) 3.82670824705E-01 Q_int 0.00000000000E+00 8.20792870054E-10 3.33953254045E-09 7.64330346389E-09 1.38226805622E-08 2.19718579141E-08 3.21887820219E-08 4.45752898192E-08 5.92372515831E-08 7.62847189244E-08 9.58320780335E-08 1.17998208364E-07 1.42906646944E-07 1.70685758520E-07 2.01468911719E-07 2.35394661460E-07 2.72606937822E-07 3.13255241588E-07 3.57494846719E-07 4.05487009972E-07 4.57399187939E-07 5.13405261745E-07 5.73685769681E-07 6.38428148049E-07 7.07826980508E-07 7.82084256206E-07 8.61409637018E-07 9.46020734195E-07 1.03614339477E-06 1.13201199804E-06 1.23386976247E-06 1.34196906343E-06 1.45657176209E-06 1.57794954587E-06 1.70638428086E-06 1.84216837665E-06 1.98560516394E-06 2.13700928544E-06 2.29670710043E-06 2.46503710365E-06 2.64235035871E-06 2.82901094685E-06 3.02539643136E-06 3.23189833827E-06 3.44892265394E-06 3.67689034003E-06 3.91623786651E-06 4.16741776337E-06 4.43089919162E-06 4.70716853422E-06 4.99673000777E-06 5.30010629555E-06 5.61783920267E-06 5.95049033420E-06 6.29864179688E-06 6.66289692548E-06 7.04388103444E-06 7.44224219582E-06 7.85865204433E-06 8.29380661057E-06 8.74842718330E-06 9.22326120173E-06 9.71908317910E-06 1.02366956583E-05 1.07769302009E-05 1.13406484106E-05 1.19287429927E-05 1.25421388498E-05 1.31817942163E-05 1.38487018320E-05 1.45438901571E-05 1.52684246290E-05 1.60234089630E-05 1.68099864984E-05 1.76293415912E-05 1.84827010560E-05 1.93713356566E-05 2.02965616501E-05 2.12597423838E-05 2.22622899475E-05 2.33056668839E-05 2.43913879580E-05 2.55210219880E-05 2.66961937399E-05 2.79185858882E-05 2.91899410444E-05 3.05120638560E-05 3.18868231784E-05 3.33161543223E-05 3.48020613793E-05 3.63466196278E-05 3.79519780226E-05 3.96203617713E-05 4.13540749996E-05 4.31555035091E-05 4.50271176310E-05 4.69714751787E-05 4.89912245030E-05 5.10891076527E-05 5.32679636455E-05 5.55307318516E-05 5.78804554952E-05 6.03202852769E-05 6.28534831219E-05 6.54834260582E-05 6.82136102284E-05 7.10476550417E-05 7.39893074687E-05 7.70424464853E-05 8.02110876705E-05 8.34993879634E-05 8.69116505851E-05 9.04523301303E-05 9.41260378357E-05 9.79375470308E-05 1.01891798777E-04 1.05993907702E-04 1.10249168035E-04 1.14663059853E-04 1.19241255542E-04 1.23989626479E-04 1.28914249948E-04 1.34021416299E-04 1.39317636342E-04 1.44809649012E-04 1.50504429286E-04 1.56409196383E-04 1.62531422240E-04 1.68878840286E-04 1.75459454517E-04 1.82281548885E-04 1.89353697008E-04 1.96684772222E-04 2.04283957972E-04 2.12160758570E-04 2.20325010315E-04 2.28786893007E-04 2.37556941849E-04 2.46646059764E-04 2.56065530138E-04 2.65827029999E-04 2.75942643655E-04 2.86424876795E-04 2.97286671082E-04 3.08541419251E-04 3.20202980718E-04 3.32285697736E-04 3.44804412101E-04 3.57774482440E-04 3.71211802086E-04 3.85132817576E-04 3.99554547781E-04 4.14494603696E-04 4.29971208911E-04 4.46003220785E-04 4.62610152350E-04 4.79812194968E-04 4.97630241762E-04 5.16085911862E-04 5.35201575474E-04 5.55000379818E-04 5.75506275952E-04 5.96744046515E-04 6.18739334432E-04 6.41518672595E-04 6.65109514563E-04 6.89540266321E-04 7.14840319120E-04 7.41040083451E-04 7.68171024173E-04 7.96265696857E-04 8.25357785364E-04 8.55482140711E-04 8.86674821273E-04 9.18973134358E-04 9.52415679195E-04 9.87042391407E-04 1.02289458899E-03 1.06001501986E-03 1.09844791106E-03 1.13823901958E-03 1.17943568497E-03 1.22208688372E-03 1.26624328550E-03 1.31195731131E-03 1.35928319362E-03 1.40827703853E-03 1.45899689008E-03 1.51150279674E-03 1.56585688014E-03 1.62212340611E-03 1.68036885820E-03 1.74066201367E-03 1.80307402198E-03 1.86767848603E-03 1.93455154613E-03 2.00377196679E-03 2.07542122641E-03 2.14958361007E-03 2.22634630543E-03 2.30579950180E-03 2.38803649262E-03 2.47315378138E-03 2.56125119104E-03 2.65243197717E-03 2.74680294493E-03 2.84447456986E-03 2.94556112280E-03 3.05018079896E-03 3.15845585129E-03 3.27051272831E-03 3.38648221655E-03 3.50649958769E-03 3.63070475059E-03 3.75924240843E-03 3.89226222096E-03 4.02991897220E-03 4.17237274363E-03 4.31978909309E-03 4.47233923961E-03 4.63020025428E-03 4.79355525738E-03 4.96259362197E-03 5.13751118416E-03 5.31851046018E-03 5.50580087056E-03 5.69959897157E-03 5.90012869419E-03 6.10762159069E-03 6.32231708933E-03 6.54446275713E-03 6.77431457105E-03 7.01213719796E-03 7.25820428340E-03 7.51279874962E-03 7.77621310301E-03 8.04874975121E-03 8.33072133033E-03 8.62245104225E-03 8.92427300259E-03 9.23653259946E-03 9.55958686331E-03 9.89380484828E-03 1.02395680251E-02 1.05972706861E-02 1.09673203628E-02 1.13501382554E-02 1.17461596762E-02 1.21558345054E-02 1.25796276610E-02 1.30180195825E-02 1.34715067286E-02 1.39406020898E-02 1.44258357154E-02 1.49277552561E-02 1.54469265218E-02 1.59839340552E-02 1.65393817218E-02 1.71138933157E-02 1.77081131828E-02 1.83227068602E-02 1.89583617336E-02 1.96157877115E-02 2.02957179178E-02 2.09989094018E-02 2.17261438666E-02 2.24782284159E-02 2.32559963195E-02 2.40603077972E-02 2.48920508213E-02 2.57521419389E-02 2.66415271119E-02 2.75611825766E-02 2.85121157224E-02 2.94953659886E-02 3.05120057806E-02 3.15631414037E-02 3.26499140159E-02 3.37735005982E-02 3.49351149421E-02 3.61360086545E-02 3.73774721789E-02 3.86608358318E-02 3.99874708546E-02 4.13587904792E-02 4.27762510067E-02 4.42413528977E-02 4.57556418732E-02 4.73207100246E-02 4.89381969309E-02 5.06097907818E-02 5.23372295036E-02 5.41223018872E-02 5.59668487147E-02 5.78727638812E-02 5.98419955111E-02 6.18765470633E-02 6.39784784227E-02 6.61499069740E-02 6.83930086542E-02 7.07100189772E-02 7.31032340280E-02 7.55750114189E-02 7.81277712029E-02 8.07639967369E-02 8.34862354898E-02 8.62970997844E-02 8.91992674687E-02 9.21954825049E-02 9.52885554689E-02 9.84813639479E-02 1.01776852827E-01 1.05178034451E-01 1.08687988652E-01 1.12309862626E-01 1.16046870642E-01 1.19902293579E-01 1.23879478254E-01 1.27981836549E-01 1.32212844293E-01 1.36576039898E-01 1.41075022710E-01 1.45713451072E-01 1.50495040053E-01 1.55423558835E-01 1.60502827717E-01 1.65736714713E-01 1.71129131713E-01 1.76684030173E-01 1.82405396291E-01 1.88297245649E-01 1.94363617264E-01 2.00608567021E-01 2.07036160429E-01 2.13650464677E-01 2.20455539912E-01 2.27455429723E-01 2.34654150746E-01 2.42055681359E-01 2.49663949400E-01 2.57482818843E-01 2.65516075387E-01 2.73767410878E-01 2.82240406505E-01 2.90938514702E-01 2.99865039694E-01 3.09023116594E-01 3.18415689009E-01 3.28045485062E-01 3.37914991756E-01 3.48026427624E-01 3.58381713577E-01 3.68982441876E-01 3.79829843182E-01 3.90924751584E-01 4.02267567576E-01 4.13858218893E-01 4.25696119188E-01 4.37780124469E-01 4.50108487300E-01 4.62678808699E-01 4.75487987768E-01 4.88532169010E-01 5.01806687395E-01 5.15306011187E-01 5.29023682603E-01 5.42952256396E-01 5.57083236471E-01 5.71407010682E-01 5.85912784007E-01 6.00588510300E-01 6.15420822911E-01 6.30394964477E-01 6.45494716256E-01 6.60702327425E-01 6.75998444832E-01 6.91362043755E-01 7.06770360284E-01 7.22198826034E-01 7.37621005951E-01 7.53008540079E-01 7.68331090216E-01 7.83556292490E-01 7.98649716967E-01 8.13574835462E-01 8.28292998860E-01 8.42763425248E-01 8.56943200311E-01 8.70787291429E-01 8.84248576995E-01 8.97277892474E-01 9.09824094742E-01 9.21834146186E-01 9.33253220017E-01 9.44024828129E-01 9.54090972700E-01 9.63392322554E-01 9.71868415037E-01 9.79457883887E-01 9.86098713211E-01 9.91728517252E-01 9.96284845185E-01 9.99705509604E-01 1.00192893684E+00 1.00289453661E+00 1.00254308787E+00 1.00081713724E+00 9.97661405667E-01 9.93023198823E-01 9.86852816159E-01 9.79103953868E-01 9.69734097099E-01 9.58704897670E-01 9.45982534839E-01 9.31538058730E-01 9.15347718851E-01 8.97393283967E-01 8.77662364421E-01 8.56148753990E-01 8.32852815456E-01 8.07781942228E-01 7.80951137260E-01 7.52383759800E-01 7.22112499363E-01 6.90180643753E-01 6.56643712270E-01 6.21571524459E-01 5.85050765894E-01 5.47188092108E-01 5.08113775388E-01 4.67985841623E-01 4.26994560051E-01 3.85367031863E-01 3.43371469322E-01 3.01320563236E-01 2.59573106056E-01 2.18532783438E-01 1.78642797231E-01 1.40374792871E-01 1.04210530015E-01 7.06150167147E-02 4.00006794391E-02 1.26839606763E-02 -1.11608716023E-02 -3.15400444053E-02 -4.86503701227E-02 -6.28252456913E-02 -7.43574537691E-02 -8.32698343205E-02 -8.94763871382E-02 -9.29236890571E-02 -9.36066759796E-02 -9.15839226877E-02 -8.69947152511E-02 -8.00765195360E-02 -7.11804557760E-02 -6.07811465227E-02 -4.94758991473E-02 -3.79668415188E-02 -2.70188159137E-02 -1.73864122069E-02 -9.70698753667E-03 -4.36539253111E-03 -1.35452373937E-03 -1.90364715935E-04 -1.31153388917E-06 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1.64589665286E+01 -8.78754285806E+01 1.43171189676E+02 2.22780084871E+02 -1.50929794378E+03 3.01187021529E+03 -2.79510101726E+03 1.01244482740E+03 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1 3 1 i j (l(j)) 0.00000000000E+00 Q_int 0.00000000000E+00 -2.21442226314E-15 -1.81735009035E-14 -6.29262329862E-14 -1.53037721270E-13 -3.06697516879E-13 -5.43834691497E-13 -8.86240028458E-13 -1.35769574379E-12 -1.98411317108E-12 -2.79367886808E-12 -3.81700962845E-12 -5.08731690857E-12 -6.64058120789E-12 -8.51573697058E-12 -1.07548686081E-11 -1.34034182745E-11 -1.65104060628E-11 -2.01286633245E-11 -2.43150798565E-11 -2.91308657381E-11 -3.46418286432E-11 -4.09186675017E-11 -4.80372834268E-11 -5.60791088791E-11 -6.51314560897E-11 -7.52878858199E-11 -8.66485975965E-11 -9.93208426187E-11 -1.13419360604E-10 -1.29066841904E-10 -1.46394416300E-10 -1.65542169948E-10 -1.86659692059E-10 -2.09906652935E-10 -2.35453415116E-10 -2.63481679460E-10 -2.94185168093E-10 -3.27770346250E-10 -3.64457185170E-10 -4.04479968284E-10 -4.48088143099E-10 -4.95547221268E-10 -5.47139729512E-10 -6.03166214167E-10 -6.63946302300E-10 -7.29819822496E-10 -8.01147988573E-10 -8.78314649668E-10 -9.61727610313E-10 -1.05182002433E-09 -1.14905186655E-09 -1.25391148665E-09 -1.36691724944E-09 -1.48861926652E-09 -1.61960122406E-09 -1.76048231203E-09 -1.91191926042E-09 -2.07460848811E-09 -2.24928837065E-09 -2.43674163330E-09 -2.63779787616E-09 -2.85333623842E-09 -3.08428820944E-09 -3.33164059443E-09 -3.59643864311E-09 -3.87978935021E-09 -4.18286493697E-09 -4.50690652350E-09 -4.85322800218E-09 -5.22322012302E-09 -5.61835480223E-09 -6.04018966625E-09 -6.49037284354E-09 -6.97064801786E-09 -7.48285975663E-09 -8.02895912953E-09 -8.61100963263E-09 -9.23119343453E-09 -9.89181796179E-09 -1.05953228418E-08 -1.13442872219E-08 -1.21414374861E-08 -1.29896553882E-08 -1.38919866269E-08 -1.48516498831E-08 -1.58720463473E-08 -1.69567697600E-08 -1.81096169958E-08 -1.93345992171E-08 -2.06359536307E-08 -2.20181558765E-08 -2.34859330849E-08 -2.50442776359E-08 -2.66984616594E-08 -2.84540523147E-08 -3.03169278913E-08 -3.22932947745E-08 -3.43897053226E-08 -3.66130767025E-08 -3.89707107360E-08 -4.14703148105E-08 -4.41200239099E-08 -4.69284238251E-08 -4.99045756084E-08 -5.30580413356E-08 -5.63989112466E-08 -5.99378323371E-08 -6.36860384789E-08 -6.76553821489E-08 -7.18583678532E-08 -7.63081873352E-08 -8.10187566630E-08 -8.60047552951E-08 -9.12816672294E-08 -9.68658243457E-08 -1.02774452058E-07 -1.09025717401E-07 -1.15638779670E-07 -1.22633843769E-07 -1.30032216386E-07 -1.37856365167E-07 -1.46129981026E-07 -1.54878043782E-07 -1.64126891275E-07 -1.73904292156E-07 -1.84239522551E-07 -1.95163446788E-07 -2.06708602419E-07 -2.18909289748E-07 -2.31801666117E-07 -2.45423845190E-07 -2.59816001507E-07 -2.75020480584E-07 -2.91081914847E-07 -3.08047345715E-07 -3.25966352154E-07 -3.44891186043E-07 -3.64876914711E-07 -3.85981571023E-07 -4.08266311422E-07 -4.31795582331E-07 -4.56637295366E-07 -4.82863011834E-07 -5.10548136980E-07 -5.39772124527E-07 -5.70618692031E-07 -6.03176047630E-07 -6.37537128790E-07 -6.73799853672E-07 -7.12067385802E-07 -7.52448412724E-07 -7.95057439393E-07 -8.40015097080E-07 -8.87448468598E-07 -9.37491430727E-07 -9.90285014726E-07 -1.04597778591E-06 -1.10472624327E-06 -1.16669524023E-06 -1.23205842760E-06 -1.30099871998E-06 -1.37370878676E-06 -1.45039156908E-06 -1.53126082411E-06 -1.61654169806E-06 -1.70647132945E-06 -1.80129948433E-06 -1.90128922490E-06 -2.00671761364E-06 -2.11787645445E-06 -2.23507307310E-06 -2.35863113879E-06 -2.48889152919E-06 -2.62621324116E-06 -2.77097434954E-06 -2.92357301668E-06 -3.08442855527E-06 -3.25398254733E-06 -3.43270002236E-06 -3.62107069773E-06 -3.81961028470E-06 -4.02886186338E-06 -4.24939733051E-06 -4.48181892367E-06 -4.72676082621E-06 -4.98489085702E-06 -5.25691224967E-06 -5.54356552573E-06 -5.84563046723E-06 -6.16392819347E-06 -6.49932334782E-06 -6.85272640036E-06 -7.22509607237E-06 -7.61744188934E-06 -8.03082686928E-06 -8.46637035346E-06 -8.92525098726E-06 -9.40870985913E-06 -9.91805380603E-06 -1.04546588943E-05 -1.10199740852E-05 -1.16155250956E-05 -1.22429184626E-05 -1.29038458256E-05 -1.36000884350E-05 -1.43335219009E-05 -1.51061211947E-05 -1.59199659165E-05 -1.67772458434E-05 -1.76802667731E-05 -1.86314566791E-05 -1.96333721941E-05 -2.06887054393E-05 -2.18002912180E-05 -2.29711145940E-05 -2.42043188747E-05 -2.55032140206E-05 -2.68712855058E-05 -2.83122036514E-05 -2.98298334607E-05 -3.14282449802E-05 -3.31117242167E-05 -3.48847846412E-05 -3.67521793099E-05 -3.87189136371E-05 -4.07902588557E-05 -4.29717662018E-05 -4.52692818644E-05 -4.76889627406E-05 -5.02372930418E-05 -5.29211017969E-05 -5.57475813018E-05 -5.87243065677E-05 -6.18592558229E-05 -6.51608321259E-05 -6.86378861524E-05 -7.22997402201E-05 -7.61562136199E-05 -8.02176493264E-05 -8.44949421647E-05 -8.89995685138E-05 -9.37436176323E-05 -9.87398246976E-05 -1.04001605654E-04 -1.09543093971E-04 -1.15379179417E-04 -1.21525548968E-04 -1.27998729964E-04 -1.34816135639E-04 -1.41996113168E-04 -1.49557994366E-04 -1.57522149189E-04 -1.65910042193E-04 -1.74744292133E-04 -1.84048734861E-04 -1.93848489725E-04 -2.04170029660E-04 -2.15041255192E-04 -2.26491572561E-04 -2.38551976224E-04 -2.51255135958E-04 -2.64635488856E-04 -2.78729336484E-04 -2.93574947483E-04 -3.09212665957E-04 -3.25685025959E-04 -3.43036872430E-04 -3.61315488975E-04 -3.80570732848E-04 -4.00855177588E-04 -4.22224263734E-04 -4.44736458076E-04 -4.68453421964E-04 -4.93440189166E-04 -5.19765353851E-04 -5.47501269268E-04 -5.76724257742E-04 -6.07514832642E-04 -6.39957933009E-04 -6.74143171565E-04 -7.10165096886E-04 -7.48123470538E-04 -7.88123560037E-04 -8.30276448536E-04 -8.74699362190E-04 -9.21516016197E-04 -9.70856980581E-04 -1.02286006681E-03 -1.07767073644E-03 -1.13544253298E-03 -1.19633753829E-03 -1.26052685488E-03 -1.32819111541E-03 -1.39952102107E-03 -1.47471791022E-03 -1.55399435888E-03 -1.63757481498E-03 -1.72569626781E-03 -1.81860895473E-03 -1.91657710690E-03 -2.01987973596E-03 -2.12881146377E-03 -2.24368339717E-03 -2.36482404990E-03 -2.49258031382E-03 -2.62731848173E-03 -2.76942532383E-03 -2.91930922021E-03 -3.07740135149E-03 -3.24415694991E-03 -3.42005661304E-03 -3.60560768209E-03 -3.80134568712E-03 -4.00783586071E-03 -4.22567472218E-03 -4.45549173360E-03 -4.69795102917E-03 -4.95375321869E-03 -5.22363726596E-03 -5.50838244221E-03 -5.80881035419E-03 -6.12578704607E-03 -6.46022517338E-03 -6.81308624665E-03 -7.18538294119E-03 -7.57818146851E-03 -7.99260400368E-03 -8.42983116118E-03 -8.89110451077E-03 -9.37772912220E-03 -9.89107612644E-03 -1.04325852780E-02 -1.10037675008E-02 -1.16062073968E-02 -1.22415656932E-02 -1.29115816013E-02 -1.36180750550E-02 -1.43629487918E-02 -1.51481902377E-02 -1.59758731470E-02 -1.68481589462E-02 -1.77672977232E-02 -1.87356287944E-02 -1.97555807785E-02 -2.08296710938E-02 -2.19605047885E-02 -2.31507726054E-02 -2.44032481687E-02 -2.57207841754E-02 -2.71063074564E-02 -2.85628127655E-02 -3.00933551416E-02 -3.17010406741E-02 -3.33890154931E-02 -3.51604527905E-02 -3.70185376687E-02 -3.89664495973E-02 -4.10073422539E-02 -4.31443205096E-02 -4.53804143155E-02 -4.77185492397E-02 -5.01615134019E-02 -5.27119205552E-02 -5.53721690670E-02 -5.81443965666E-02 -6.10304300425E-02 -6.40317311978E-02 -6.71493369101E-02 -7.03837946845E-02 -7.37350930526E-02 -7.72025869359E-02 -8.07849180889E-02 -8.44799308400E-02 -8.82845834770E-02 -9.21948557760E-02 -9.62056533449E-02 -1.00310709656E-01 -1.04502486871E-01 -1.08772076812E-01 -1.13109103740E-01 -1.17501630891E-01 -1.21936073089E-01 -1.26397118120E-01 -1.30867659938E-01 -1.35328747187E-01 -1.39759550943E-01 -1.44137355990E-01 -1.48437580316E-01 -1.52633827889E-01 -1.56697980048E-01 -1.60600331020E-01 -1.64309773148E-01 -1.67794037284E-01 -1.71019993477E-01 -1.73954016420E-01 -1.76562419190E-01 -1.78811957381E-01 -1.80670403855E-01 -1.82107191845E-01 -1.83094120995E-01 -1.83606117067E-01 -1.83622031298E-01 -1.83125459853E-01 -1.82105557365E-01 -1.80557811197E-01 -1.78484734974E-01 -1.75896431144E-01 -1.72810963212E-01 -1.69254469175E-01 -1.65260939175E-01 -1.60871573202E-01 -1.56133629930E-01 -1.51098676588E-01 -1.45820153960E-01 -1.40350181919E-01 -1.34735551768E-01 -1.29012884553E-01 -1.23202982354E-01 -1.17304465200E-01 -1.11286872493E-01 -1.05083516928E-01 -9.85845121058E-02 -9.16305517120E-02 -8.40081950560E-02 -7.54476032454E-02 -6.56238592322E-02 -5.41631721115E-02 -4.06553802286E-02 -2.46741846861E-02 -5.80640567270E-03 1.63088174188E-02 4.19306579210E-02 7.11579704262E-02 1.03863972718E-01 1.39629130267E-01 1.77680132439E-01 2.16846473373E-01 2.55550123371E-01 2.91847450455E-01 3.23544652461E-01 3.48406199249E-01 3.64466268316E-01 3.70429503981E-01 3.66099462260E-01 3.52684916442E-01 3.32681359253E-01 3.08784444395E-01 2.82069553203E-01 2.52891901235E-01 2.21747133200E-01 1.89312210231E-01 1.56444550746E-01 1.24159669029E-01 9.35814051579E-02 6.58607037031E-02 4.20627399770E-02 2.30285261602E-02 9.22623891476E-03 6.19128623974E-04 -3.41037824164E-03 -4.03037028745E-03 -2.77228380079E-03 -1.16008380844E-03 -2.05594634160E-04 -1.51006129700E-06 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 -6.28802006536E+00 -7.04693842521E+01 1.50711432527E+03 -9.35504106899E+03 2.87316034549E+04 -4.73383500889E+04 4.00025525584E+04 -1.36273064526E+04 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1 4 1 i j (l(j)) 0.00000000000E+00 Q_int 0.00000000000E+00 -1.46503193642E-15 -1.20233433069E-14 -4.16311474717E-14 -1.01247692223E-13 -2.02906937385E-13 -3.59793684459E-13 -5.86324415937E-13 -8.98233116170E-13 -1.31266236085E-12 -1.84825997804E-12 -2.52528160046E-12 -3.36569944651E-12 -4.39331768604E-12 -5.63389476669E-12 -7.11527309722E-12 -8.86751650613E-12 -1.09230559169E-11 -1.33168437058E-11 -1.60865172324E-11 -1.92725720629E-11 -2.29185454302E-11 -2.70712105099E-11 -3.17807821181E-11 -3.71011344737E-11 -4.30900317008E-11 -4.98093717848E-11 -5.73254447338E-11 -6.57092057396E-11 -7.50365641728E-11 -8.53886892960E-11 -9.68523336224E-11 -1.09520174903E-10 -1.23491177771E-10 -1.38870976141E-10 -1.55772277504E-10 -1.74315290327E-10 -1.94628175847E-10 -2.16847525593E-10 -2.41118866048E-10 -2.67597191971E-10 -2.96447529921E-10 -3.27845533675E-10 -3.61978113261E-10 -3.99044099477E-10 -4.39254945817E-10 -4.82835469868E-10 -5.30024636325E-10 -5.81076383905E-10 -6.36260498554E-10 -6.95863535475E-10 -7.60189792628E-10 -8.29562338520E-10 -9.04324097224E-10 -9.84838993748E-10 -1.07149316304E-09 -1.16469622603E-09 -1.26488263649E-09 -1.37251310230E-09 -1.48807608543E-09 -1.61208938474E-09 -1.74510180602E-09 -1.88769492420E-09 -2.04048494251E-09 -2.20412465389E-09 -2.37930551020E-09 -2.56675980501E-09 -2.76726297608E-09 -2.98163603401E-09 -3.21074812380E-09 -3.45551922656E-09 -3.71692300876E-09 -3.99598982710E-09 -4.29380989725E-09 -4.61153663533E-09 -4.95039018130E-09 -5.31166111416E-09 -5.69671436903E-09 -6.10699336714E-09 -6.54402437003E-09 -7.00942106985E-09 -7.50488942865E-09 -8.03223277964E-09 -8.59335720477E-09 -9.19027720304E-09 -9.82512166534E-09 -1.05001401720E-08 -1.12177096304E-08 -1.19803412706E-08 -1.27906880181E-08 -1.36515522642E-08 -1.45658940544E-08 -1.55368397177E-08 -1.65676909603E-08 -1.76619344475E-08 -1.88232519010E-08 -2.00555307384E-08 -2.13628752832E-08 -2.27496185763E-08 -2.42203348213E-08 -2.57798524957E-08 -2.74332681648E-08 -2.91859610353E-08 -3.10436082867E-08 -3.30122012232E-08 -3.50980622892E-08 -3.73078629927E-08 -3.96486427870E-08 -4.21278289595E-08 -4.47532575818E-08 -4.75331955769E-08 -5.04763639631E-08 -5.35919623355E-08 -5.68896946523E-08 -6.03797963929E-08 -6.40730631617E-08 -6.79808808136E-08 -7.21152571805E-08 -7.64888554848E-08 -8.11150295272E-08 -8.60078607442E-08 -9.11821972319E-08 -9.66536948415E-08 -1.02438860454E-07 -1.08555097548E-07 -1.15020754190E-07 -1.21855173555E-07 -1.29078747137E-07 -1.36712970764E-07 -1.44780503589E-07 -1.53305230194E-07 -1.62312325986E-07 -1.71828326039E-07 -1.81881197592E-07 -1.92500416361E-07 -2.03717046891E-07 -2.15563827148E-07 -2.28075257577E-07 -2.41287694857E-07 -2.55239450605E-07 -2.69970895278E-07 -2.85524567563E-07 -3.01945289518E-07 -3.19280287786E-07 -3.37579321196E-07 -3.56894815068E-07 -3.77282002599E-07 -3.98799073678E-07 -4.21507331533E-07 -4.45471357609E-07 -4.70759185111E-07 -4.97442481666E-07 -5.25596741581E-07 -5.55301488184E-07 -5.86640486797E-07 -6.19701968875E-07 -6.54578867898E-07 -6.91369067639E-07 -7.30175663432E-07 -7.71107237139E-07 -8.14278146507E-07 -8.59808829682E-07 -9.07826125650E-07 -9.58463611450E-07 -1.01186195702E-06 -1.06816929856E-06 -1.12754163150E-06 -1.19014322384E-06 -1.25614705120E-06 -1.32573525457E-06 -1.39909962180E-06 -1.47644209441E-06 -1.55797530062E-06 -1.64392311629E-06 -1.73452125497E-06 -1.83001788876E-06 -1.93067430140E-06 -2.03676557535E-06 -2.14858131458E-06 -2.26642640492E-06 -2.39062181387E-06 -2.52150543195E-06 -2.65943295769E-06 -2.80477882845E-06 -2.95793719956E-06 -3.11932297406E-06 -3.28937288583E-06 -3.46854663871E-06 -3.65732810444E-06 -3.85622658260E-06 -4.06577812550E-06 -4.28654693147E-06 -4.51912680995E-06 -4.76414272210E-06 -5.02225240067E-06 -5.29414805326E-06 -5.58055815304E-06 -5.88224932156E-06 -6.20002830809E-06 -6.53474407049E-06 -6.88728996267E-06 -7.25860603404E-06 -7.64968144648E-06 -8.06155701492E-06 -8.49532787738E-06 -8.95214630137E-06 -9.43322463303E-06 -9.93983839641E-06 -1.04733295503E-05 -1.10351099100E-05 -1.16266647435E-05 -1.22495565483E-05 -1.29054290207E-05 -1.35960112246E-05 -1.43231219706E-05 -1.50886744163E-05 -1.58946808974E-05 -1.67432580010E-05 -1.76366318942E-05 -1.85771439187E-05 -1.95672564647E-05 -2.06095591387E-05 -2.17067752373E-05 -2.28617685433E-05 -2.40775504588E-05 -2.53572874909E-05 -2.67043091076E-05 -2.81221159802E-05 -2.96143886320E-05 -3.11849965096E-05 -3.28380074997E-05 -3.45776979092E-05 -3.64085629317E-05 -3.83353276215E-05 -4.03629583993E-05 -4.24966751129E-05 -4.47419636780E-05 -4.71045893255E-05 -4.95906104813E-05 -5.22063933079E-05 -5.49586269355E-05 -5.78543394132E-05 -6.09009144117E-05 -6.41061087088E-05 -6.74780704913E-05 -7.10253585079E-05 -7.47569621089E-05 -7.86823222067E-05 -8.28113531987E-05 -8.71544658880E-05 -9.17225914420E-05 -9.65272064326E-05 -1.01580358995E-04 -1.06894696153E-04 -1.12483492348E-04 -1.18360679226E-04 -1.24540876719E-04 -1.31039425467E-04 -1.37872420637E-04 -1.45056747176E-04 -1.52610116552E-04 -1.60551105026E-04 -1.68899193511E-04 -1.77674809055E-04 -1.86899368012E-04 -1.96595320929E-04 -2.06786199220E-04 -2.17496663641E-04 -2.28752554655E-04 -2.40580944680E-04 -2.53010192310E-04 -2.66069998511E-04 -2.79791464852E-04 -2.94207153794E-04 -3.09351151079E-04 -3.25259130221E-04 -3.41968419159E-04 -3.59518069048E-04 -3.77948925231E-04 -3.97303700377E-04 -4.17627049787E-04 -4.38965648867E-04 -4.61368272727E-04 -4.84885877895E-04 -5.09571686098E-04 -5.35481270055E-04 -5.62672641220E-04 -5.91206339395E-04 -6.21145524119E-04 -6.52556067722E-04 -6.85506649918E-04 -7.20068853785E-04 -7.56317262974E-04 -7.94329559960E-04 -8.34186625113E-04 -8.75972636384E-04 -9.19775169323E-04 -9.65685297160E-04 -1.01379769065E-03 -1.06421071736E-03 -1.11702653996E-03 -1.17235121330E-03 -1.23029477964E-03 -1.29097136183E-03 -1.35449925378E-03 -1.42100100783E-03 -1.49060351855E-03 -1.56343810239E-03 -1.63964057259E-03 -1.71935130899E-03 -1.80271532202E-03 -1.88988231041E-03 -1.98100671212E-03 -2.07624774791E-03 -2.17576945728E-03 -2.27974072614E-03 -2.38833530613E-03 -2.50173182521E-03 -2.62011378954E-03 -2.74366957663E-03 -2.87259242001E-03 -3.00708038601E-03 -3.14733634315E-03 -3.29356792553E-03 -3.44598749127E-03 -3.60481207824E-03 -3.77026335915E-03 -3.94256759919E-03 -4.12195561976E-03 -4.30866277270E-03 -4.50292893043E-03 -4.70499849822E-03 -4.91512045612E-03 -5.13354843936E-03 -5.36054086732E-03 -5.59636113303E-03 -5.84127786693E-03 -6.09556529046E-03 -6.35950367763E-03 -6.63337994496E-03 -6.91748839308E-03 -7.21213162628E-03 -7.51762167953E-03 -7.83428138622E-03 -8.16244602379E-03 -8.50246527836E-03 -8.85470557456E-03 -9.21955282091E-03 -9.59741562688E-03 -9.98872905273E-03 -1.03939589590E-02 -1.08136070286E-02 -1.12482165401E-02 -1.16983789767E-02 -1.21647415627E-02 -1.26480158228E-02 -1.31489872676E-02 -1.36685263116E-02 -1.42076005363E-02 -1.47672884120E-02 -1.53487945964E-02 -1.59534669267E-02 -1.65828152202E-02 -1.72385319953E-02 -1.79225152157E-02 -1.86368931501E-02 -1.93840514237E-02 -2.01666623150E-02 -2.09877163274E-02 -2.18505560243E-02 -2.27589120791E-02 -2.37169414352E-02 -2.47292674069E-02 -2.58010214789E-02 -2.69378864704E-02 -2.81461406274E-02 -2.94327020860E-02 -3.08051730118E-02 -3.22718825675E-02 -3.38419276835E-02 -3.55252104148E-02 -3.73324704556E-02 -3.92753111515E-02 -4.13662171035E-02 -4.36185611977E-02 -4.60465986284E-02 -4.86654452083E-02 -5.14910369962E-02 -5.45400680232E-02 -5.78299026788E-02 -6.13784591447E-02 -6.52040601614E-02 -6.93252473965E-02 -7.37605557952E-02 -7.85282445543E-02 -8.36459818267E-02 -8.91304809579E-02 -9.49970870494E-02 -1.01259313975E-01 -1.07928333707E-01 -1.15012421995E-01 -1.22516367140E-01 -1.30440851854E-01 -1.38781822047E-01 -1.47529860862E-01 -1.56669591302E-01 -1.66179136470E-01 -1.76029672441E-01 -1.86185115191E-01 -1.96601989319E-01 -2.07229532301E-01 -2.18010093127E-01 -2.28879887721E-01 -2.39770174678E-01 -2.50608912474E-01 -2.61322952126E-01 -2.71840805771E-01 -2.82096009984E-01 -2.92031071061E-01 -3.01601935813E-01 -3.10782873935E-01 -3.19571584940E-01 -3.27994253237E-01 -3.36110169423E-01 -3.44015416220E-01 -3.51844988837E-01 -3.59772590224E-01 -3.68007225903E-01 -3.76785641215E-01 -3.86359625308E-01 -3.96977290142E-01 -4.08857669910E-01 -4.22158438776E-01 -4.36937284010E-01 -4.53108572956E-01 -4.70398481463E-01 -4.88303743000E-01 -5.06061593043E-01 -5.22641145864E-01 -5.36768928124E-01 -5.47002770398E-01 -5.51867219453E-01 -5.50057514361E-01 -5.40703756748E-01 -5.23655474787E-01 -4.99688812704E-01 -4.70437902676E-01 -4.37694330893E-01 -4.02215994089E-01 -3.64328329712E-01 -3.24489777230E-01 -2.83326911358E-01 -2.41639889668E-01 -2.00390812338E-01 -1.60669430767E-01 -1.23631670207E-01 -9.04089475684E-02 -6.19907356785E-02 -3.90896085853E-02 -2.20071444385E-02 -1.05299286203E-02 -3.89550737083E-03 -8.73897020252E-04 -1.55776891495E-06 3.74527119390E-05 3.64377515139E-07 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 -4.16006936883E+00 7.98700664511E+01 -1.07073845639E+03 6.34667208521E+03 -1.93152926143E+04 3.17083950088E+04 -2.67274767381E+04 9.08577921417E+03 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2 2 0 i j (l(j)) -1.12798023663E-01 Q_int 0.00000000000E+00 -3.78533125062E-10 -1.54012508482E-09 -3.52493747264E-09 -6.37474161537E-09 -1.01329779214E-08 -1.48448173405E-08 -2.05572250102E-08 -2.73190261637E-08 -3.51809743802E-08 -4.41958222580E-08 -5.44183945966E-08 -6.59056641741E-08 -7.87168302120E-08 -9.29133996197E-08 -1.08559271118E-07 -1.25720822339E-07 -1.44467000010E-07 -1.64869413328E-07 -1.87002430634E-07 -2.10943279500E-07 -2.36772150361E-07 -2.64572303799E-07 -2.94430181614E-07 -3.26435521818E-07 -3.60681477678E-07 -3.97264740962E-07 -4.36285669524E-07 -4.77848419384E-07 -5.22061081461E-07 -5.69035823114E-07 -6.18889034672E-07 -6.71741481105E-07 -7.27718459044E-07 -7.86949959305E-07 -8.49570835134E-07 -9.15720976359E-07 -9.85545489655E-07 -1.05919488514E-06 -1.13682526951E-06 -1.21859854599E-06 -1.30468262120E-06 -1.39525161941E-06 -1.49048610419E-06 -1.59057330790E-06 -1.69570736914E-06 -1.80608957861E-06 -1.92192863355E-06 -2.04344090098E-06 -2.17085069036E-06 -2.30439053556E-06 -2.44430148687E-06 -2.59083341312E-06 -2.74424531441E-06 -2.90480564571E-06 -3.07279265188E-06 -3.24849471424E-06 -3.43221070938E-06 -3.62425038042E-06 -3.82493472124E-06 -4.03459637416E-06 -4.25358004144E-06 -4.48224291119E-06 -4.72095509805E-06 -4.97010009938E-06 -5.23007526717E-06 -5.50129229659E-06 -5.78417773139E-06 -6.07917348704E-06 -6.38673739202E-06 -6.70734374802E-06 -7.04148390956E-06 -7.38966688388E-06 -7.75241995170E-06 -8.13028930948E-06 -8.52384073420E-06 -8.93366027111E-06 -9.36035494551E-06 -9.80455349923E-06 -1.02669071527E-05 -1.07480903937E-05 -1.12488017931E-05 -1.17697648495E-05 -1.23117288629E-05 -1.28754698385E-05 -1.34617914227E-05 -1.40715258706E-05 -1.47055350479E-05 -1.53647114669E-05 -1.60499793594E-05 -1.67622957858E-05 -1.75026517834E-05 -1.82720735545E-05 -1.90716236950E-05 -1.99024024669E-05 -2.07655491136E-05 -2.16622432219E-05 -2.25937061305E-05 -2.35612023877E-05 -2.45660412596E-05 -2.56095782906E-05 -2.66932169175E-05 -2.78184101405E-05 -2.89866622513E-05 -3.01995306213E-05 -3.14586275518E-05 -3.27656221884E-05 -3.41222425014E-05 -3.55302773348E-05 -3.69915785267E-05 -3.85080631027E-05 -4.00817155452E-05 -4.17145901411E-05 -4.34088134117E-05 -4.51665866251E-05 -4.69901883971E-05 -4.88819773810E-05 -5.08443950505E-05 -5.28799685798E-05 -5.49913138220E-05 -5.71811383914E-05 -5.94522448517E-05 -6.18075340151E-05 -6.42500083547E-05 -6.67827755354E-05 -6.94090520661E-05 -7.21321670790E-05 -7.49555662387E-05 -7.78828157861E-05 -8.09176067230E-05 -8.40637591402E-05 -8.73252266953E-05 -9.07061012449E-05 -9.42106176372E-05 -9.78431586691E-05 -1.01608260215E-04 -1.05510616533E-04 -1.09555085751E-04 -1.13746695548E-04 -1.18090649024E-04 -1.22592330777E-04 -1.27257313190E-04 -1.32091362930E-04 -1.37100447677E-04 -1.42290743078E-04 -1.47668639946E-04 -1.53240751705E-04 -1.59013922091E-04 -1.64995233118E-04 -1.71192013317E-04 -1.77611846263E-04 -1.84262579388E-04 -1.91152333104E-04 -1.98289510238E-04 -2.05682805783E-04 -2.13341217002E-04 -2.21274053859E-04 -2.29490949819E-04 -2.38001873024E-04 -2.46817137837E-04 -2.55947416798E-04 -2.65403752978E-04 -2.75197572767E-04 -2.85340699093E-04 -2.95845365096E-04 -3.06724228272E-04 -3.17990385104E-04 -3.29657386185E-04 -3.41739251868E-04 -3.54250488448E-04 -3.67206104898E-04 -3.80621630174E-04 -3.94513131120E-04 -4.08897230971E-04 -4.23791128506E-04 -4.39212617838E-04 -4.55180108888E-04 -4.71712648557E-04 -4.88829942618E-04 -5.06552378354E-04 -5.24901047969E-04 -5.43897772792E-04 -5.63565128310E-04 -5.83926470047E-04 -6.05005960327E-04 -6.26828595939E-04 -6.49420236754E-04 -6.72807635297E-04 -6.97018467331E-04 -7.22081363479E-04 -7.48025941907E-04 -7.74882842124E-04 -8.02683759914E-04 -8.31461483457E-04 -8.61249930660E-04 -8.92084187758E-04 -9.24000549205E-04 -9.57036558914E-04 -9.91231052882E-04 -1.02662420325E-03 -1.06325756382E-03 -1.10117411717E-03 -1.14041832323E-03 -1.18103616958E-03 -1.22307522342E-03 -1.26658468519E-03 -1.31161544411E-03 -1.35822013546E-03 -1.40645319980E-03 -1.45637094418E-03 -1.50803160535E-03 -1.56149541509E-03 -1.61682466765E-03 -1.67408378949E-03 -1.73333941124E-03 -1.79466044210E-03 -1.85811814664E-03 -1.92378622409E-03 -1.99174089032E-03 -2.06206096240E-03 -2.13482794595E-03 -2.21012612538E-03 -2.28804265693E-03 -2.36866766488E-03 -2.45209434074E-03 -2.53841904570E-03 -2.62774141637E-03 -2.72016447385E-03 -2.81579473635E-03 -2.91474233541E-03 -3.01712113568E-03 -3.12304885868E-03 -3.23264721030E-03 -3.34604201243E-03 -3.46336333859E-03 -3.58474565394E-03 -3.71032795948E-03 -3.84025394088E-03 -3.97467212172E-03 -4.11373602159E-03 -4.25760431893E-03 -4.40644101881E-03 -4.56041562585E-03 -4.71970332226E-03 -4.88448515127E-03 -5.05494820593E-03 -5.23128582361E-03 -5.41369778604E-03 -5.60239052536E-03 -5.79757733596E-03 -5.99947859256E-03 -6.20832197436E-03 -6.42434269562E-03 -6.64778374267E-03 -6.87889611745E-03 -7.11793908782E-03 -7.36518044460E-03 -7.62089676556E-03 -7.88537368641E-03 -8.15890617894E-03 -8.44179883629E-03 -8.73436616558E-03 -9.03693288787E-03 -9.34983424557E-03 -9.67341631732E-03 -1.00080363404E-02 -1.03540630409E-02 -1.07118769709E-02 -1.10818708540E-02 -1.14644499380E-02 -1.18600323550E-02 -1.22690494894E-02 -1.26919463527E-02 -1.31291819666E-02 -1.35812297519E-02 -1.40485779257E-02 -1.45317299046E-02 -1.50312047149E-02 -1.55475374090E-02 -1.60812794878E-02 -1.66329993286E-02 -1.72032826189E-02 -1.77927327942E-02 -1.84019714804E-02 -1.90316389403E-02 -1.96823945227E-02 -2.03549171142E-02 -2.10499055922E-02 -2.17680792792E-02 -2.25101783962E-02 -2.32769645153E-02 -2.40692210098E-02 -2.48877535002E-02 -2.57333902956E-02 -2.66069828282E-02 -2.75094060793E-02 -2.84415589961E-02 -2.94043648952E-02 -3.03987718534E-02 -3.14257530810E-02 -3.24863072766E-02 -3.35814589608E-02 -3.47122587846E-02 -3.58797838109E-02 -3.70851377653E-02 -3.83294512512E-02 -3.96138819279E-02 -4.09396146456E-02 -4.23078615328E-02 -4.37198620331E-02 -4.51768828835E-02 -4.66802180318E-02 -4.82311884843E-02 -4.98311420796E-02 -5.14814531810E-02 -5.31835222801E-02 -5.49387755043E-02 -5.67486640203E-02 -5.86146633242E-02 -6.05382724103E-02 -6.25210128067E-02 -6.45644274702E-02 -6.66700795271E-02 -6.88395508491E-02 -7.10744404526E-02 -7.33763627076E-02 -7.57469453429E-02 -7.81878272328E-02 -8.07006559503E-02 -8.32870850713E-02 -8.59487712111E-02 -8.86873707783E-02 -9.15045364249E-02 -9.44019131749E-02 -9.73811342100E-02 -1.00443816293E-01 -1.03591554803E-01 -1.06825918366E-01 -1.10148443049E-01 -1.13560626101E-01 -1.17063919208E-01 -1.20659721241E-01 -1.24349370470E-01 -1.28134136209E-01 -1.32015209877E-01 -1.35993695430E-01 -1.40070599150E-01 -1.44246818748E-01 -1.48523131765E-01 -1.52900183225E-01 -1.57378472528E-01 -1.61958339537E-01 -1.66639949839E-01 -1.71423279163E-01 -1.76308096896E-01 -1.81293948713E-01 -1.86380138266E-01 -1.91565707928E-01 -1.96849418565E-01 -2.02229728333E-01 -2.07704770481E-01 -2.13272330149E-01 -2.18929820179E-01 -2.24674255927E-01 -2.30502229099E-01 -2.36409880631E-01 -2.42392872634E-01 -2.48446359465E-01 -2.54564957950E-01 -2.60742716843E-01 -2.66973085595E-01 -2.73248882522E-01 -2.79562262489E-01 -2.85904684243E-01 -2.92266877543E-01 -2.98638810265E-01 -3.05009655683E-01 -3.11367760157E-01 -3.17700611476E-01 -3.23994808172E-01 -3.30236030099E-01 -3.36409010674E-01 -3.42497511168E-01 -3.48484297497E-01 -3.54351120031E-01 -3.60078696947E-01 -3.65646701744E-01 -3.71033755576E-01 -3.76217425125E-01 -3.81174226798E-01 -3.85879638097E-01 -3.90308117090E-01 -3.94433130957E-01 -3.98227194693E-01 -4.01661921087E-01 -4.04708083192E-01 -4.07335690565E-01 -4.09514080610E-01 -4.11212026443E-01 -4.12397862720E-01 -4.13039630925E-01 -4.13105245638E-01 -4.12562683292E-01 -4.11380194907E-01 -4.09526544217E-01 -4.06971272510E-01 -4.03684991318E-01 -3.99639703874E-01 -3.94809155928E-01 -3.89169216105E-01 -3.82698285461E-01 -3.75377735217E-01 -3.67192370838E-01 -3.58130919625E-01 -3.48186537786E-01 -3.37357331530E-01 -3.25646885117E-01 -3.13064786871E-01 -2.99627142098E-01 -2.85357059525E-01 -2.70285095411E-01 -2.54449636977E-01 -2.37897204321E-01 -2.20682647843E-01 -2.02869216510E-01 -1.84528471592E-01 -1.65740021144E-01 -1.46591053174E-01 -1.27175650850E-01 -1.07593882201E-01 -8.79506705007E-02 -6.83544710314E-02 -4.89158061988E-02 -2.97457447065E-02 -1.09544519522E-02 7.35001332749E-03 2.50624297400E-02 4.20803968489E-02 5.83032644672E-02 7.36297037065E-02 8.79536883847E-02 1.01158850206E-01 1.13111569376E-01 1.23653886328E-01 1.32598553481E-01 1.39730556350E-01 1.44822613528E-01 1.47676903678E-01 1.48178928058E-01 1.46273745241E-01 1.41950609075E-01 1.35255030430E-01 1.26303166422E-01 1.15296929242E-01 1.02538235362E-01 8.84399031380E-02 7.35296021577E-02 5.84420659940E-02 4.38937367422E-02 3.06335804195E-02 1.93648423683E-02 1.06364307692E-02 4.71182158182E-03 1.44168615956E-03 1.99981311314E-04 1.45434135923E-06 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 -7.59054356213E+00 4.71835640023E+01 -1.27200581135E+02 2.42699753926E+02 -4.31440762079E+02 6.22022534490E+02 -5.34772977851E+02 1.92025039959E+02 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2 3 1 i j (l(j)) 0.00000000000E+00 Q_int 0.00000000000E+00 -7.00680509550E-15 -5.75040183256E-14 -1.99109200690E-13 -4.84237125216E-13 -9.70442590202E-13 -1.72078452552E-12 -2.80421262398E-12 -4.29597779839E-12 -6.27806783702E-12 -8.83966970652E-12 -1.20776600314E-11 -1.60971253639E-11 -2.10119139480E-11 -2.69452207735E-11 -3.40302078172E-11 -4.24106614725E-11 -5.22416892772E-11 -6.36904581668E-11 -7.69369766034E-11 -9.21749230577E-11 -1.09612523458E-10 -1.29473480366E-10 -1.51997956782E-10 -1.77443617654E-10 -2.06086732324E-10 -2.38223341312E-10 -2.74170491058E-10 -3.14267540390E-10 -3.58877542735E-10 -4.08388708293E-10 -4.63215950596E-10 -5.23802522184E-10 -5.90621744290E-10 -6.64178835793E-10 -7.45012846902E-10 -8.33698703367E-10 -9.30849367341E-10 -1.03711812130E-09 -1.15320098184E-09 -1.27983925043E-09 -1.41782220878E-09 -1.56798996662E-09 -1.73123647040E-09 -1.90851268158E-09 -2.10082993397E-09 -2.30926347982E-09 -2.53495623496E-09 -2.77912273395E-09 -3.04305330668E-09 -3.32811848844E-09 -3.63577367626E-09 -3.96756404490E-09 -4.32512973662E-09 -4.71021133963E-09 -5.12465567087E-09 -5.57042187970E-09 -6.04958788989E-09 -6.56435719816E-09 -7.11706604877E-09 -7.71019100436E-09 -8.34635693453E-09 -9.02834544479E-09 -9.75910376959E-09 -1.05417541546E-08 -1.13796037543E-08 -1.22761550737E-08 -1.32351169816E-08 -1.42604163283E-08 -1.53562101991E-08 -1.65268988377E-08 -1.77771392762E-08 -1.91118597092E-08 -2.05362746523E-08 -2.20559009265E-08 -2.36765745137E-08 -2.54044683290E-08 -2.72461109602E-08 -2.92084064248E-08 -3.12986550007E-08 -3.35245751860E-08 -3.58943268509E-08 -3.84165356428E-08 -4.11003187133E-08 -4.39553118375E-08 -4.69916979991E-08 -5.02202375207E-08 -5.36522998206E-08 -5.72998968845E-08 -6.11757185409E-08 -6.52931696396E-08 -6.96664092314E-08 -7.43103918588E-08 -7.92409110671E-08 -8.44746452559E-08 -9.00292059952E-08 -9.59231889370E-08 -1.02176227460E-07 -1.08809049191E-07 -1.15843535566E-07 -1.23302784569E-07 -1.31211176850E-07 -1.39594445371E-07 -1.48479748782E-07 -1.57895748733E-07 -1.67872691306E-07 -1.78442492808E-07 -1.89638830151E-07 -2.01497236049E-07 -2.14055199307E-07 -2.27352270456E-07 -2.41430173025E-07 -2.56332920744E-07 -2.72106940994E-07 -2.88801204835E-07 -3.06467363961E-07 -3.25159894935E-07 -3.44936251117E-07 -3.65857022657E-07 -3.87986105005E-07 -4.11390876376E-07 -4.36142384647E-07 -4.62315544177E-07 -4.89989343086E-07 -5.19247061528E-07 -5.50176501556E-07 -5.82870229175E-07 -6.17425829232E-07 -6.53946173824E-07 -6.92539704923E-07 -7.33320731985E-07 -7.76409745311E-07 -8.21933746012E-07 -8.70026593432E-07 -9.20829370962E-07 -9.74490771202E-07 -1.03116750150E-06 -1.09102471093E-06 -1.15423643983E-06 -1.22098609314E-06 -1.29146693868E-06 -1.36588263177E-06 -1.44444776762E-06 -1.52738846277E-06 -1.61494296728E-06 -1.70736230923E-06 -1.80491097317E-06 -1.90786761441E-06 -2.01652581088E-06 -2.13119485476E-06 -2.25220058568E-06 -2.37988626791E-06 -2.51461351371E-06 -2.65676325534E-06 -2.80673676825E-06 -2.96495674803E-06 -3.13186844417E-06 -3.30794085340E-06 -3.49366797576E-06 -3.68957013684E-06 -3.89619537940E-06 -4.11412092822E-06 -4.34395473198E-06 -4.58633708598E-06 -4.84194234031E-06 -5.11148069755E-06 -5.39570010499E-06 -5.69538824607E-06 -6.01137463643E-06 -6.34453282987E-06 -6.69578274007E-06 -7.06609308404E-06 -7.45648395375E-06 -7.86802952252E-06 -8.30186089324E-06 -8.75916909592E-06 -9.24120824217E-06 -9.74929884495E-06 -1.02848313122E-05 -1.08492696231E-05 -1.14441551973E-05 -1.20711109659E-05 -1.27318456560E-05 -1.34281582989E-05 -1.41619429743E-05 -1.49351938024E-05 -1.57500101968E-05 -1.66086023923E-05 -1.75132972604E-05 -1.84665444300E-05 -1.94709227262E-05 -2.05291469462E-05 -2.16440749880E-05 -2.28187153515E-05 -2.40562350306E-05 -2.53599678167E-05 -2.67334230350E-05 -2.81802947357E-05 -2.97044713648E-05 -3.13100459374E-05 -3.30013267413E-05 -3.47828485971E-05 -3.66593847046E-05 -3.86359591046E-05 -4.07178597893E-05 -4.29106524929E-05 -4.52201951997E-05 -4.76526534048E-05 -5.02145161670E-05 -5.29126129955E-05 -5.57541316110E-05 -5.87466366285E-05 -6.18980892085E-05 -6.52168677253E-05 -6.87117895059E-05 -7.23921336939E-05 -7.62676652962E-05 -8.03486604723E-05 -8.46459331315E-05 -8.91708629025E-05 -9.39354245481E-05 -9.89522188963E-05 -1.04234505368E-04 -1.09796236177E-04 -1.15652092297E-04 -1.21817521278E-04 -1.28308777002E-04 -1.35142961490E-04 -1.42338068853E-04 -1.49913031500E-04 -1.57887768714E-04 -1.66283237721E-04 -1.75121487372E-04 -1.84425714570E-04 -1.94220323590E-04 -2.04530988419E-04 -2.15384718285E-04 -2.26809926527E-04 -2.38836502968E-04 -2.51495889979E-04 -2.64821162402E-04 -2.78847111540E-04 -2.93610333402E-04 -3.09149321423E-04 -3.25504563872E-04 -3.42718646193E-04 -3.60836358502E-04 -3.79904808513E-04 -3.99973540145E-04 -4.21094658093E-04 -4.43322958655E-04 -4.66716067117E-04 -4.91334582012E-04 -5.17242226589E-04 -5.44506007838E-04 -5.73196383430E-04 -6.03387436961E-04 -6.35157061883E-04 -6.68587154540E-04 -7.03763816750E-04 -7.40777568364E-04 -7.79723570282E-04 -8.20701858422E-04 -8.63817589129E-04 -9.09181296579E-04 -9.56909162710E-04 -1.00712330027E-03 -1.05995204956E-03 -1.11553028954E-03 -1.17399976384E-03 -1.23550942250E-03 -1.30021577996E-03 -1.36828329019E-03 -1.43988473957E-03 -1.51520165835E-03 -1.59442475151E-03 -1.67775434983E-03 -1.76540088196E-03 -1.85758536852E-03 -1.95453993892E-03 -2.05650837210E-03 -2.16374666189E-03 -2.27652360818E-03 -2.39512143475E-03 -2.51983643495E-03 -2.65097964617E-03 -2.78887755419E-03 -2.93387282861E-03 -3.08632509038E-03 -3.24661171252E-03 -3.41512865540E-03 -3.59229133737E-03 -3.77853554232E-03 -3.97431836495E-03 -4.18011919515E-03 -4.39644074254E-03 -4.62381010229E-03 -4.86277986342E-03 -5.11392926048E-03 -5.37786536982E-03 -5.65522435136E-03 -5.94667273670E-03 -6.25290876463E-03 -6.57466376449E-03 -6.91270358838E-03 -7.26783009241E-03 -7.64088266770E-03 -8.03273982109E-03 -8.44432080573E-03 -8.87658730151E-03 -9.33054514458E-03 -9.80724610572E-03 -1.03077897162E-02 -1.08333251403E-02 -1.13850530918E-02 -1.19642277940E-02 -1.25721589792E-02 -1.32102139247E-02 -1.38798195229E-02 -1.45824643795E-02 -1.53197009359E-02 -1.60931476097E-02 -1.69044909465E-02 -1.77554877753E-02 -1.86479673596E-02 -1.95838335333E-02 -2.05650668112E-02 -2.15937264614E-02 -2.26719525262E-02 -2.38019677754E-02 -2.49860795749E-02 -2.62266816520E-02 -2.75262557361E-02 -2.88873730503E-02 -3.03126956304E-02 -3.18049774397E-02 -3.33670652516E-02 -3.50018992632E-02 -3.67125134031E-02 -3.85020352938E-02 -4.03736858208E-02 -4.23307782624E-02 -4.43767169259E-02 -4.65149952324E-02 -4.87491931872E-02 -5.10829741701E-02 -5.35200809693E-02 -5.60643309835E-02 -5.87196105041E-02 -6.14898679887E-02 -6.43791062263E-02 -6.73913732908E-02 -7.05307521698E-02 -7.38013489510E-02 -7.72072794377E-02 -8.07526540608E-02 -8.44415609441E-02 -8.82780469748E-02 -9.22660967196E-02 -9.64096090241E-02 -1.00712371122E-01 -1.05178030077E-01 -1.09810061372E-01 -1.14611734454E-01 -1.19586075049E-01 -1.24735824036E-01 -1.30063392698E-01 -1.35570814136E-01 -1.41259690667E-01 -1.47131137004E-01 -1.53185719043E-01 -1.59423388089E-01 -1.65843410365E-01 -1.72444291670E-01 -1.79223697088E-01 -1.86178365674E-01 -1.93304020072E-01 -2.00595271092E-01 -2.08045517309E-01 -2.15646839812E-01 -2.23389892314E-01 -2.31263786920E-01 -2.39255975928E-01 -2.47352130182E-01 -2.55536014578E-01 -2.63789361491E-01 -2.72091743037E-01 -2.80420443221E-01 -2.88750331246E-01 -2.97053737404E-01 -3.05300333203E-01 -3.13457017590E-01 -3.21487811344E-01 -3.29353761953E-01 -3.37012861516E-01 -3.44419980421E-01 -3.51526819801E-01 -3.58281885920E-01 -3.64630489879E-01 -3.70514776107E-01 -3.75873783250E-01 -3.80643541097E-01 -3.84757207128E-01 -3.88145246200E-01 -3.90735656655E-01 -3.92454245832E-01 -3.93224957535E-01 -3.92970253458E-01 -3.91611549907E-01 -3.89069710330E-01 -3.85265593293E-01 -3.80120654537E-01 -3.73557600712E-01 -3.65501091374E-01 -3.55878484899E-01 -3.44620623208E-01 -3.31662649791E-01 -3.16944855514E-01 -3.00413547387E-01 -2.82021936898E-01 -2.61731047036E-01 -2.39510640758E-01 -2.15340178583E-01 -1.89209819347E-01 -1.61121485603E-01 -1.31090023641E-01 -9.91444967344E-02 -6.53296581042E-02 -2.97076554052E-02 7.63998091352E-03 4.66100205511E-02 8.70748624288E-02 1.28879521222E-01 1.71838341684E-01 2.15731597175E-01 2.60302245779E-01 3.05253263441E-01 3.50246138896E-01 3.94901272584E-01 4.38801116466E-01 4.81496822234E-01 5.22518754620E-01 5.61390181634E-01 5.97641300514E-01 6.30816746545E-01 6.60462704643E-01 6.86067922153E-01 7.06912047879E-01 7.21894578923E-01 7.29648571867E-01 7.28708374937E-01 7.17602065123E-01 6.94988832586E-01 6.59844534019E-01 6.11692180638E-01 5.50863565464E-01 4.78762880569E-01 3.98082863998E-01 3.12899971491E-01 2.28551242354E-01 1.51180822429E-01 8.68559994159E-02 4.02230479217E-02 1.28580600229E-02 1.86217584123E-03 1.18262468936E-05 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 -1.98963548215E+01 1.17052411161E+02 -1.75794029963E+02 -3.37462892987E+02 1.84584891324E+03 -3.30189611530E+03 2.82491850708E+03 -9.65289229216E+02 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2 4 1 i j (l(j)) 0.00000000000E+00 Q_int 0.00000000000E+00 6.32404922528E-15 5.19007218818E-14 1.79707636962E-13 4.37052176393E-13 8.75880893934E-13 1.55310814229E-12 2.53096503042E-12 3.87736988491E-12 5.66632145436E-12 7.97831616465E-12 1.09007908052E-11 1.45285921030E-11 1.89644747214E-11 2.43196293053E-11 3.07142422857E-11 3.82780892474E-11 4.71511637666E-11 5.74843437274E-11 6.94400972389E-11 8.31932303878E-11 9.89316791882E-11 1.16857348215E-10 1.37186998548E-10 1.60153187792E-10 1.86005265098E-10 2.15010424260E-10 2.47454818130E-10 2.83644737795E-10 3.23907860091E-10 3.68594567306E-10 4.18079343040E-10 4.72762248494E-10 5.33070483616E-10 5.99460037832E-10 6.72417435311E-10 7.52461579989E-10 8.40145705864E-10 9.36059438372E-10 1.04083097297E-09 1.15512937736E-09 1.27966702420E-09 1.41520216139E-09 1.56254162759E-09 1.72254372083E-09 1.89612122870E-09 2.08424462891E-09 2.28794546945E-09 2.50831993842E-09 2.74653263360E-09 3.00382054278E-09 3.28149724645E-09 3.58095735468E-09 3.90368119126E-09 4.25123973827E-09 4.62529985541E-09 5.02762978893E-09 5.46010498586E-09 5.92471423013E-09 6.42356611805E-09 6.95889589141E-09 7.53307264769E-09 8.14860694758E-09 8.80815884158E-09 9.51454633789E-09 1.02707543359E-08 1.10799440498E-08 1.19454629494E-08 1.28708552455E-08 1.38598729492E-08 1.49164875362E-08 1.60449022488E-08 1.72495650691E-08 1.85351824006E-08 1.99067334949E-08 2.13694856649E-08 2.29290103252E-08 2.45911999058E-08 2.63622856839E-08 2.82488565843E-08 3.02578790004E-08 3.23967176891E-08 3.46731577983E-08 3.70954280873E-08 3.96722254029E-08 4.24127404795E-08 4.53266851334E-08 4.84243209253E-08 5.17164893697E-08 5.52146437743E-08 5.89308827944E-08 6.28779857958E-08 6.70694501216E-08 7.15195303635E-08 7.62432797456E-08 8.12565937325E-08 8.65762559795E-08 9.22199867504E-08 9.82064939330E-08 1.04555526791E-07 1.11287932598E-07 1.18425716303E-07 1.25992103399E-07 1.34011606143E-07 1.42510093336E-07 1.51514863822E-07 1.61054723920E-07 1.71160068995E-07 1.81862969381E-07 1.93197260900E-07 2.05198640197E-07 2.17904765176E-07 2.31355360779E-07 2.45592330407E-07 2.60659873280E-07 2.76604608042E-07 2.93475702947E-07 3.11325012979E-07 3.30207224255E-07 3.50180006119E-07 3.71304171307E-07 3.93643844641E-07 4.17266640662E-07 4.42243850716E-07 4.68650639959E-07 4.96566254819E-07 5.26074241463E-07 5.57262675857E-07 5.90224406009E-07 6.25057307061E-07 6.61864549896E-07 7.00754883965E-07 7.41842935099E-07 7.85249519077E-07 8.31101971793E-07 8.79534496891E-07 9.30688531781E-07 9.84713133014E-07 1.04176538203E-06 1.10201081232E-06 1.16562385922E-06 1.23278833338E-06 1.30369791931E-06 1.37855670017E-06 1.45757971034E-06 1.54099351705E-06 1.62903683281E-06 1.72196115999E-06 1.82003146954E-06 1.92352691534E-06 2.03274158633E-06 2.14798529814E-06 2.26958442654E-06 2.39788278467E-06 2.53324254652E-06 2.67604521901E-06 2.82669266521E-06 2.98560818139E-06 3.15323763075E-06 3.33005063674E-06 3.51654183912E-06 3.71323221608E-06 3.92067047581E-06 4.13943452117E-06 4.37013299133E-06 4.61340688437E-06 4.86993126502E-06 5.14041706214E-06 5.42561296043E-06 5.72630739149E-06 6.04333062927E-06 6.37755699542E-06 6.72990718030E-06 7.10135068568E-06 7.49290839540E-06 7.90565528077E-06 8.34072324771E-06 8.79930413301E-06 9.28265285740E-06 9.79209074381E-06 1.03290090092E-05 1.08948724391E-05 1.14912232547E-05 1.21196851812E-05 1.27819677306E-05 1.34798707064E-05 1.42152889453E-05 1.49902173057E-05 1.58067559173E-05 1.66671157044E-05 1.75736241979E-05 1.85287316507E-05 1.95350174718E-05 2.05951969960E-05 2.17121286076E-05 2.28888212341E-05 2.41284422313E-05 2.54343256793E-05 2.68099811099E-05 2.82591026894E-05 2.97855788787E-05 3.13935025963E-05 3.30871819098E-05 3.48711512839E-05 3.67501834125E-05 3.87293016660E-05 4.08137931850E-05 4.30092226544E-05 4.53214467916E-05 4.77566295871E-05 5.03212583355E-05 5.30221604974E-05 5.58665214352E-05 5.88619030676E-05 6.20162634899E-05 6.53379776098E-05 6.88358588505E-05 7.25191819759E-05 7.63977070953E-05 8.04817049082E-05 8.47819832517E-05 8.93099150180E-05 9.40774675112E-05 9.90972333174E-05 1.04382462763E-04 1.09947098048E-04 1.15805809128E-04 1.21974031446E-04 1.28468005604E-04 1.35304819063E-04 1.42502449990E-04 1.50079813350E-04 1.58056809355E-04 1.66454374398E-04 1.75294534587E-04 1.84600462017E-04 1.94396533912E-04 2.04708394785E-04 2.15563021760E-04 2.26988793228E-04 2.39015560985E-04 2.51674726036E-04 2.64999318250E-04 2.79024080044E-04 2.93785554310E-04 3.09322176783E-04 3.25674373075E-04 3.42884660602E-04 3.60997755643E-04 3.80060685784E-04 4.00122908008E-04 4.21236432708E-04 4.43455953905E-04 4.66838985978E-04 4.91446007211E-04 5.17340610498E-04 5.44589661536E-04 5.73263464866E-04 6.03435938140E-04 6.35184795009E-04 6.68591737015E-04 7.03742654942E-04 7.40727840046E-04 7.79642205630E-04 8.20585519457E-04 8.63662647472E-04 9.08983809385E-04 9.56664846636E-04 1.00682750331E-03 1.05959972058E-03 1.11511594532E-03 1.17351745344E-03 1.23495268868E-03 1.29957761754E-03 1.36755610093E-03 1.43906028340E-03 1.51427100069E-03 1.59337820628E-03 1.67658141782E-03 1.76409018425E-03 1.85612457448E-03 1.95291568847E-03 2.05470619162E-03 2.16175087343E-03 2.27431723133E-03 2.39268608072E-03 2.51715219210E-03 2.64802495648E-03 2.78562907984E-03 2.93030530803E-03 3.08241118281E-03 3.24232183041E-03 3.41043078352E-03 3.58715083781E-03 3.77291494414E-03 3.96817713753E-03 4.17341350388E-03 4.38912318564E-03 4.61582942739E-03 4.85408066234E-03 5.10445164077E-03 5.36754460137E-03 5.64399048627E-03 5.93445020066E-03 6.23961591770E-03 6.56021242943E-03 6.89699854407E-03 7.25076853036E-03 7.62235360892E-03 8.01262349109E-03 8.42248796487E-03 8.85289852785E-03 9.30485006662E-03 9.77938258182E-03 1.02775829578E-02 1.08005867757E-02 1.13495801673E-02 1.19258017093E-02 1.25305443533E-02 1.31651573898E-02 1.38310484418E-02 1.45296854847E-02 1.52625988862E-02 1.60313834616E-02 1.68377005379E-02 1.76832800184E-02 1.85699224414E-02 1.94995010218E-02 2.04739636655E-02 2.14953349467E-02 2.25657180320E-02 2.36872965392E-02 2.48623363139E-02 2.60931871058E-02 2.73822841259E-02 2.87321494612E-02 3.01453933260E-02 3.16247151206E-02 3.31729042709E-02 3.47928408174E-02 3.64874957183E-02 3.82599308310E-02 4.01132985318E-02 4.20508409281E-02 4.40758886182E-02 4.61918589453E-02 4.84022536920E-02 5.07106561541E-02 5.31207275303E-02 5.56362025584E-02 5.82608843240E-02 6.09986381626E-02 6.38533845692E-02 6.68290910273E-02 6.99297626582E-02 7.31594315909E-02 7.65221449426E-02 8.00219512972E-02 8.36628855583E-02 8.74489520536E-02 9.13841057534E-02 9.54722314680E-02 9.97171208768E-02 1.04122447239E-01 1.08691737632E-01 1.13428342555E-01 1.18335402739E-01 1.23415812989E-01 1.28672182901E-01 1.34106794273E-01 1.39721555055E-01 1.45517949661E-01 1.51496985496E-01 1.57659135535E-01 1.64004276818E-01 1.70531624738E-01 1.77239662998E-01 1.84126069159E-01 1.91187635722E-01 1.98420186690E-01 2.05818489649E-01 2.13376163394E-01 2.21085581216E-01 2.28937770020E-01 2.36922305490E-01 2.45027203632E-01 2.53238809094E-01 2.61541680759E-01 2.69918475251E-01 2.78349829083E-01 2.86814240353E-01 2.95287951037E-01 3.03744831102E-01 3.12156265855E-01 3.20491048170E-01 3.28715277420E-01 3.36792267243E-01 3.44682464478E-01 3.52343381919E-01 3.59729547817E-01 3.66792475359E-01 3.73480655670E-01 3.79739578207E-01 3.85511782722E-01 3.90736947275E-01 3.95352017078E-01 3.99291379201E-01 4.02487088371E-01 4.04869149280E-01 4.06365860832E-01 4.06904227765E-01 4.06410444865E-01 4.04810458643E-01 4.02030610778E-01 3.97998366793E-01 3.92643132288E-01 3.85897157547E-01 3.77696529436E-01 3.67982247056E-01 3.56701374709E-01 3.43808262202E-01 3.29265818348E-01 3.13046818736E-01 2.95135223520E-01 2.75527474979E-01 2.54233738466E-01 2.31279043959E-01 2.06704279579E-01 1.80566983436E-01 1.52941877189E-01 1.23921084897E-01 9.36139855944E-02 6.21466601601E-02 2.96609145443E-02 -3.68710345227E-03 -3.77286247033E-02 -7.22841730227E-02 -1.07165428358E-01 -1.42176660046E-01 -1.77115180622E-01 -2.11770061440E-01 -2.45918105309E-01 -2.79315800641E-01 -3.11685712185E-01 -3.42695542356E-01 -3.71928016361E-01 -3.98839942590E-01 -4.22707493084E-01 -4.42601900410E-01 -4.57425748057E-01 -4.65990253688E-01 -4.67081484995E-01 -4.59562746959E-01 -4.42514497105E-01 -4.15409917121E-01 -3.78316383779E-01 -3.32101530939E-01 -2.78607203354E-01 -2.20736229715E-01 -1.62378474739E-01 -1.08090651355E-01 -6.24519126063E-02 -2.90681827053E-02 -9.33447239528E-03 -1.35739928361E-03 -8.56255461902E-06 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1.79576177130E+01 -1.05824628753E+02 2.52128867929E+02 -3.67752011818E+02 4.51020924268E+02 -5.05867032417E+02 3.79081586576E+02 -1.20659045290E+02 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 3 3 1 i j (l(j)) 2.09760189978E+00 Q_int 0.00000000000E+00 1.84542101033E-09 7.50840284026E-09 1.71847409101E-08 3.10780784060E-08 4.94001956139E-08 7.23713095512E-08 1.00220384254E-07 1.33185452095E-07 1.71513946516E-07 2.15463046581E-07 2.65300033749E-07 3.21302661308E-07 3.83759536911E-07 4.52970518659E-07 5.29247125225E-07 6.12912960487E-07 7.04304153197E-07 8.03769812197E-07 9.11672497731E-07 1.02838870942E-06 1.15430939145E-06 1.28984045564E-06 1.43540332294E-06 1.59143548404E-06 1.75839107976E-06 1.93674150189E-06 2.12697601520E-06 2.32960240138E-06 2.54514762565E-06 2.77415852681E-06 3.01720253160E-06 3.27486839420E-06 3.54776696166E-06 3.83653196634E-06 4.14182084611E-06 4.46431559339E-06 4.80472363406E-06 5.16377873710E-06 5.54224195628E-06 5.94090260483E-06 6.36057926426E-06 6.80212082864E-06 7.26640758540E-06 7.75435233405E-06 8.26690154409E-06 8.80503655344E-06 9.36977480887E-06 9.96217114981E-06 1.05833191371E-05 1.12343524284E-05 1.19164462013E-05 1.26308186264E-05 1.33787323923E-05 1.41614962831E-05 1.49804668117E-05 1.58370499099E-05 1.67327026771E-05 1.76689351911E-05 1.86473123811E-05 1.96694559666E-05 2.07370464637E-05 2.18518252618E-05 2.30155967722E-05 2.42302306519E-05 2.54976641053E-05 2.68199042652E-05 2.81990306579E-05 2.96371977532E-05 3.11366376040E-05 3.26996625773E-05 3.43286681810E-05 3.60261359882E-05 3.77946366638E-05 3.96368330969E-05 4.15554836414E-05 4.35534454698E-05 4.56336780435E-05 4.77992467043E-05 5.00533263900E-05 5.23992054798E-05 5.48402897734E-05 5.73801066079E-05 6.00223091186E-05 6.27706806471E-05 6.56291393032E-05 6.86017426846E-05 7.16926927614E-05 7.49063409295E-05 7.82471932400E-05 8.17199158097E-05 8.53293404200E-05 8.90804703100E-05 9.29784861700E-05 9.70287523441E-05 1.01236823247E-04 1.05608450006E-04 1.10149587326E-04 1.14866400604E-04 1.19765273283E-04 1.24852814459E-04 1.30135866757E-04 1.35621514479E-04 1.41317092033E-04 1.47230192654E-04 1.53368677428E-04 1.59740684631E-04 1.66354639383E-04 1.73219263652E-04 1.80343586587E-04 1.87736955221E-04 1.95409045541E-04 2.03369873941E-04 2.11629809070E-04 2.20199584095E-04 2.29090309383E-04 2.38313485627E-04 2.47881017420E-04 2.57805227308E-04 2.68098870319E-04 2.78775149003E-04 2.89847728989E-04 3.01330755075E-04 3.13238867887E-04 3.25587221104E-04 3.38391499278E-04 3.51667936278E-04 3.65433334369E-04 3.79705083943E-04 3.94501183942E-04 4.09840262984E-04 4.25741601215E-04 4.42225152920E-04 4.59311569918E-04 4.77022225755E-04 4.95379240747E-04 5.14405507875E-04 5.34124719582E-04 5.54561395493E-04 5.75740911092E-04 5.97689527391E-04 6.20434421620E-04 6.44003718979E-04 6.68426525483E-04 6.93732961946E-04 7.19954199130E-04 7.47122494113E-04 7.75271227909E-04 8.04434944385E-04 8.34649390522E-04 8.65951558061E-04 8.98379726590E-04 9.31973508110E-04 9.66773893145E-04 1.00282329843E-03 1.04016561627E-03 1.07884626553E-03 1.11891224448E-03 1.16041218541E-03 1.20339641108E-03 1.24791699320E-03 1.29402781286E-03 1.34178462309E-03 1.39124511353E-03 1.44246897732E-03 1.49551798036E-03 1.55045603287E-03 1.60734926343E-03 1.66626609565E-03 1.72727732733E-03 1.79045621246E-03 1.85587854599E-03 1.92362275150E-03 1.99376997193E-03 2.06640416336E-03 2.14161219207E-03 2.21948393490E-03 2.30011238305E-03 2.38359374944E-03 2.47002757980E-03 2.55951686749E-03 2.65216817233E-03 2.74809174344E-03 2.84740164633E-03 2.95021589433E-03 3.05665658454E-03 3.16685003835E-03 3.28092694690E-03 3.39902252140E-03 3.52127664865E-03 3.64783405187E-03 3.77884445697E-03 3.91446276460E-03 4.05484922798E-03 4.20016963684E-03 4.35059550762E-03 4.50630428018E-03 4.66747952117E-03 4.83431113438E-03 5.00699557820E-03 5.18573609050E-03 5.37074292119E-03 5.56223357260E-03 5.76043304815E-03 5.96557410933E-03 6.17789754151E-03 6.39765242867E-03 6.62509643754E-03 6.86049611126E-03 7.10412717305E-03 7.35627484013E-03 7.61723414824E-03 7.88731028710E-03 8.16681894725E-03 8.45608667852E-03 8.75545126061E-03 9.06526208611E-03 9.38588055645E-03 9.71768049110E-03 1.00610485505E-02 1.04163846733E-02 1.07841025280E-02 1.11646299798E-02 1.15584095734E-02 1.19658990311E-02 1.23875717686E-02 1.28239174268E-02 1.32754424223E-02 1.37426705154E-02 1.42261433977E-02 1.47264212983E-02 1.52440836107E-02 1.57797295402E-02 1.63339787728E-02 1.69074721652E-02 1.75008724593E-02 1.81148650178E-02 1.87501585863E-02 1.94074860780E-02 2.00876053860E-02 2.07913002202E-02 2.15193809731E-02 2.22726856122E-02 2.30520806020E-02 2.38584618557E-02 2.46927557169E-02 2.55559199737E-02 2.64489449045E-02 2.73728543575E-02 2.83287068640E-02 2.93175967879E-02 3.03406555106E-02 3.13990526538E-02 3.24939973403E-02 3.36267394944E-02 3.47985711829E-02 3.60108279972E-02 3.72648904787E-02 3.85621855875E-02 3.99041882167E-02 4.12924227522E-02 4.27284646801E-02 4.42139422423E-02 4.57505381428E-02 4.73399913033E-02 4.89840986721E-02 5.06847170861E-02 5.24437651867E-02 5.42632253925E-02 5.61451459281E-02 5.80916429115E-02 6.01049025008E-02 6.21871831015E-02 6.43408176355E-02 6.65682158731E-02 6.88718668290E-02 7.12543412236E-02 7.37182940101E-02 7.62664669694E-02 7.89016913727E-02 8.16268907137E-02 8.44450835102E-02 8.73593861773E-02 9.03730159713E-02 9.34892940062E-02 9.67116483426E-02 1.00043617150E-01 1.03488851941E-01 1.07051120883E-01 1.10734312178E-01 1.14542437519E-01 1.18479635618E-01 1.22550175811E-01 1.26758461727E-01 1.31109035034E-01 1.35606579253E-01 1.40255923637E-01 1.45062047123E-01 1.50030082344E-01 1.55165319699E-01 1.60473211492E-01 1.65959376117E-01 1.71629602302E-01 1.77489853396E-01 1.83546271706E-01 1.89805182862E-01 1.96273100226E-01 2.02956729320E-01 2.09862972275E-01 2.16998932291E-01 2.24371918102E-01 2.31989448433E-01 2.39859256437E-01 2.47989294113E-01 2.56387736677E-01 2.65062986880E-01 2.74023679263E-01 2.83278684326E-01 2.92837112597E-01 3.02708318585E-01 3.12901904595E-01 3.23427724382E-01 3.34295886628E-01 3.45516758204E-01 3.57100967211E-01 3.69059405749E-01 3.81403232402E-01 3.94143874391E-01 4.07293029375E-01 4.20862666848E-01 4.34865029098E-01 4.49312631691E-01 4.64218263420E-01 4.79594985680E-01 4.95456131210E-01 5.11815302154E-01 5.28686367369E-01 5.46083458922E-01 5.64020967706E-01 5.82513538104E-01 6.01576061615E-01 6.21223669366E-01 6.41471723415E-01 6.62335806750E-01 6.83831711886E-01 7.05975427942E-01 7.28783126091E-01 7.52271143253E-01 7.76455963893E-01 8.01354199794E-01 8.26982567637E-01 8.53357864240E-01 8.80496939265E-01 9.08416665215E-01 9.37133904528E-01 9.66665473524E-01 9.97028103013E-01 1.02823839528E+00 1.06031277719E+00 1.09326744916E+00 1.12711832963E+00 1.16188099475E+00 1.19757061292E+00 1.23420187375E+00 1.27178891114E+00 1.31034521993E+00 1.34988356566E+00 1.39041588707E+00 1.43195319056E+00 1.47450543626E+00 1.51808141498E+00 1.56268861532E+00 1.60833308045E+00 1.65501925357E+00 1.70274981149E+00 1.75152548534E+00 1.80134486770E+00 1.85220420522E+00 1.90409717573E+00 1.95701464913E+00 2.01094443097E+00 2.06587098790E+00 2.12177515405E+00 2.17863381766E+00 2.23641958709E+00 2.29510043566E+00 2.35463932498E+00 2.41499380634E+00 2.47611560046E+00 2.53795015582E+00 2.60043618652E+00 2.66350519098E+00 2.72708095349E+00 2.79107903141E+00 2.85540623145E+00 2.91996007999E+00 2.98462829303E+00 3.04928825302E+00 3.11380650136E+00 3.17803825694E+00 3.24182697290E+00 3.30500394614E+00 3.36738799577E+00 3.42878522943E+00 3.48898891831E+00 3.54777950410E+00 3.60492476322E+00 3.66018015529E+00 3.71328938415E+00 3.76398520053E+00 3.81199047467E+00 3.85701956607E+00 3.89878001376E+00 3.93697456534E+00 3.97130355514E+00 4.00146763059E+00 4.02717081159E+00 4.04812384911E+00 4.06404782594E+00 4.07467791531E+00 4.07976718031E+00 4.07909026080E+00 4.07244675441E+00 4.05966405695E+00 4.04059938729E+00 4.01514068709E+00 3.98320606204E+00 3.94474142726E+00 3.89971604425E+00 3.84811570511E+00 3.78993344522E+00 3.72515786889E+00 3.65375947039E+00 3.57567574661E+00 3.49079643882E+00 3.39895091379E+00 3.29990047789E+00 3.19333925244E+00 3.07890799932E+00 2.95622574264E+00 2.82494379044E+00 2.68482517636E+00 2.53584859666E+00 2.37832803959E+00 2.21302510760E+00 2.04120695713E+00 1.86456357114E+00 1.68485718024E+00 1.50333538033E+00 1.32133626734E+00 1.14059781133E+00 9.63322065131E-01 7.92181626117E-01 6.30270717747E-01 4.80981055023E-01 3.47783524801E-01 2.33902518157E-01 1.41884179077E-01 7.30875886768E-02 2.71732914420E-02 1.72670490497E-03 -7.77679684948E-03 -7.41877080046E-03 -3.51695419816E-03 -6.64479739689E-04 -5.14772274380E-06 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 3.70053441558E+01 -1.20445949001E+02 3.40177657457E+02 -1.62713463247E+03 5.35178272560E+03 -9.41462598793E+03 8.31498296075E+03 -2.91846615886E+03 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1.13306743635E+02 1.55717441727E+03 -2.35597361571E+04 1.27150808030E+05 -3.57509287055E+05 5.53058656539E+05 -4.45668782613E+05 1.46307157291E+05 3 4 1 i j (l(j)) -1.05311065050E+00 Q_int 0.00000000000E+00 -1.38096455274E-09 -5.61868435955E-09 -1.28596769497E-08 -2.32563324851E-08 -3.69671302743E-08 -5.41568629916E-08 -7.49968688706E-08 -9.96652721521E-08 -1.28347232074E-07 -1.61235200703E-07 -1.98529189918E-07 -2.40437047863E-07 -2.87174745198E-07 -3.38966671507E-07 -3.96045942188E-07 -4.58654716219E-07 -5.27044525168E-07 -6.01476613837E-07 -6.82222292954E-07 -7.69563304325E-07 -8.63792198887E-07 -9.65212728114E-07 -1.07414024923E-06 -1.19090214473E-06 -1.31583825666E-06 -1.44930133630E-06 -1.59165750954E-06 -1.74328675883E-06 -1.90458342194E-06 -2.07595670836E-06 -2.25783123389E-06 -2.45064757397E-06 -2.65486283649E-06 -2.87095125477E-06 -3.09940480132E-06 -3.34073382319E-06 -3.59546769967E-06 -3.86415552296E-06 -4.14736680286E-06 -4.44569219612E-06 -4.75974426134E-06 -5.09015824041E-06 -5.43759286730E-06 -5.80273120515E-06 -6.18628151279E-06 -6.58897814150E-06 -7.01158246324E-06 -7.45488383132E-06 -7.91970057471E-06 -8.40688102717E-06 -8.91730459229E-06 -9.45188284586E-06 -1.00115606767E-05 -1.05973174674E-05 -1.12101683164E-05 -1.18511653025E-05 -1.25213987939E-05 -1.32219988026E-05 -1.39541363863E-05 -1.47190250992E-05 -1.55179224933E-05 -1.63521316723E-05 -1.72230028993E-05 -1.81319352611E-05 -1.90803783902E-05 -2.00698342466E-05 -2.11018589623E-05 -2.21780647498E-05 -2.33001218765E-05 -2.44697607089E-05 -2.56887738275E-05 -2.69590182150E-05 -2.82824175210E-05 -2.96609644058E-05 -3.10967229656E-05 -3.25918312413E-05 -3.41485038160E-05 -3.57690345015E-05 -3.74557991193E-05 -3.92112583774E-05 -4.10379608477E-05 -4.29385460469E-05 -4.49157476239E-05 -4.69723966587E-05 -4.91114250753E-05 -5.13358691735E-05 -5.36488732835E-05 -5.60536935469E-05 -5.85537018293E-05 -6.11523897691E-05 -6.38533729660E-05 -6.66603953157E-05 -6.95773334944E-05 -7.26082015995E-05 -7.57571559507E-05 -7.90285000580E-05 -8.24266897621E-05 -8.59563385528E-05 -8.96222230717E-05 -9.34292888064E-05 -9.73826559813E-05 -1.01487625653E-04 -1.05749686016E-04 -1.10174518930E-04 -1.14768006669E-04 -1.19536238906E-04 -1.24485519942E-04 -1.29622376184E-04 -1.34953563876E-04 -1.40486077109E-04 -1.46227156101E-04 -1.52184295763E-04 -1.58365254564E-04 -1.64778063705E-04 -1.71431036604E-04 -1.78332778716E-04 -1.85492197689E-04 -1.92918513872E-04 -2.00621271185E-04 -2.08610348369E-04 -2.16895970622E-04 -2.25488721637E-04 -2.34399556058E-04 -2.43639812365E-04 -2.53221226204E-04 -2.63155944182E-04 -2.73456538133E-04 -2.84136019877E-04 -2.95207856498E-04 -3.06685986137E-04 -3.18584834336E-04 -3.30919330951E-04 -3.43704927644E-04 -3.56957615975E-04 -3.70693946128E-04 -3.84931046277E-04 -3.99686642621E-04 -4.14979080112E-04 -4.30827343898E-04 -4.47251081501E-04 -4.64270625768E-04 -4.81907018609E-04 -5.00182035550E-04 -5.19118211139E-04 -5.38738865226E-04 -5.59068130143E-04 -5.80130978829E-04 -6.01953253919E-04 -6.24561697836E-04 -6.47983983917E-04 -6.72248748616E-04 -6.97385624811E-04 -7.23425276261E-04 -7.50399433244E-04 -7.78340929426E-04 -8.07283739996E-04 -8.37263021113E-04 -8.68315150710E-04 -9.00477770697E-04 -9.33789830623E-04 -9.68291632829E-04 -1.00402487916E-03 -1.04103271926E-03 -1.07935980058E-03 -1.11905232004E-03 -1.16015807748E-03 -1.20272653097E-03 -1.24680885401E-03 -1.29245799466E-03 -1.33972873676E-03 -1.38867776316E-03 -1.43936372119E-03 -1.49184729035E-03 -1.54619125231E-03 -1.60246056332E-03 -1.66072242905E-03 -1.72104638209E-03 -1.78350436199E-03 -1.84817079810E-03 -1.91512269524E-03 -1.98443972223E-03 -2.05620430355E-03 -2.13050171403E-03 -2.20742017683E-03 -2.28705096472E-03 -2.36948850483E-03 -2.45483048701E-03 -2.54317797575E-03 -2.63463552609E-03 -2.72931130329E-03 -2.82731720672E-03 -2.92876899783E-03 -3.03378643256E-03 -3.14249339820E-03 -3.25501805489E-03 -3.37149298189E-03 -3.49205532888E-03 -3.61684697230E-03 -3.74601467698E-03 -3.87971026332E-03 -4.01809077998E-03 -4.16131868248E-03 -4.30956201781E-03 -4.46299461525E-03 -4.62179628356E-03 -4.78615301491E-03 -4.95625719550E-03 -5.13230782342E-03 -5.31451073362E-03 -5.50307883062E-03 -5.69823232878E-03 -5.90019900079E-03 -6.10921443430E-03 -6.32552229718E-03 -6.54937461160E-03 -6.78103203714E-03 -7.02076416343E-03 -7.26884981234E-03 -7.52557735026E-03 -7.79124501069E-03 -8.06616122738E-03 -8.35064497855E-03 -8.64502614239E-03 -8.94964586414E-03 -9.26485693532E-03 -9.59102418526E-03 -9.92852488543E-03 -1.02777491669E-02 -1.06391004516E-02 -1.10129958968E-02 -1.13998668553E-02 -1.18001593488E-02 -1.22143345582E-02 -1.26428693280E-02 -1.30862566883E-02 -1.35450063923E-02 -1.40196454717E-02 -1.45107188092E-02 -1.50187897293E-02 -1.55444406080E-02 -1.60882735010E-02 -1.66509107920E-02 -1.72329958613E-02 -1.78351937746E-02 -1.84581919940E-02 -1.91027011098E-02 -1.97694555958E-02 -2.04592145867E-02 -2.11727626796E-02 -2.19109107602E-02 -2.26744968523E-02 -2.34643869945E-02 -2.42814761417E-02 -2.51266890938E-02 -2.60009814512E-02 -2.69053405988E-02 -2.78407867176E-02 -2.88083738265E-02 -2.98091908527E-02 -3.08443627330E-02 -3.19150515459E-02 -3.30224576751E-02 -3.41678210050E-02 -3.53524221489E-02 -3.65775837105E-02 -3.78446715786E-02 -3.91550962563E-02 -4.05103142252E-02 -4.19118293437E-02 -4.33611942819E-02 -4.48600119917E-02 -4.64099372131E-02 -4.80126780177E-02 -4.96699973879E-02 -5.13837148340E-02 -5.31557080473E-02 -5.49879145915E-02 -5.68823336299E-02 -5.88410276905E-02 -6.08661244668E-02 -6.29598186563E-02 -6.51243738337E-02 -6.73621243603E-02 -6.96754773277E-02 -7.20669145362E-02 -7.45389945053E-02 -7.70943545167E-02 -7.97357126879E-02 -8.24658700746E-02 -8.52877128006E-02 -8.82042142137E-02 -9.12184370646E-02 -9.43335357067E-02 -9.75527583149E-02 -1.00879449119E-01 -1.04317050651E-01 -1.07869105997E-01 -1.11539261059E-01 -1.15331266816E-01 -1.19248981576E-01 -1.23296373225E-01 -1.27477521455E-01 -1.31796619979E-01 -1.36257978713E-01 -1.40866025918E-01 -1.45625310317E-01 -1.50540503142E-01 -1.55616400136E-01 -1.60857923479E-01 -1.66270123638E-01 -1.71858181128E-01 -1.77627408168E-01 -1.83583250226E-01 -1.89731287441E-01 -1.96077235891E-01 -2.02626948718E-01 -2.09386417073E-01 -2.16361770873E-01 -2.23559279350E-01 -2.30985351371E-01 -2.38646535516E-01 -2.46549519877E-01 -2.54701131573E-01 -2.63108335948E-01 -2.71778235421E-01 -2.80718067970E-01 -2.89935205225E-01 -2.99437150120E-01 -3.09231534103E-01 -3.19326113837E-01 -3.29728767389E-01 -3.40447489844E-01 -3.51490388329E-01 -3.62865676381E-01 -3.74581667644E-01 -3.86646768828E-01 -3.99069471899E-01 -4.11858345440E-01 -4.25022025137E-01 -4.38569203342E-01 -4.52508617641E-01 -4.66849038383E-01 -4.81599255098E-01 -4.96768061743E-01 -5.12364240703E-01 -5.28396545478E-01 -5.44873681971E-01 -5.61804288303E-01 -5.79196913061E-01 -5.97059991888E-01 -6.15401822315E-01 -6.34230536732E-01 -6.53554073373E-01 -6.73380145200E-01 -6.93716206557E-01 -7.14569417432E-01 -7.35946605194E-01 -7.57854223609E-01 -7.80298308973E-01 -8.03284433143E-01 -8.26817653251E-01 -8.50902457850E-01 -8.75542709244E-01 -9.00741581679E-01 -9.26501495106E-01 -9.52824044142E-01 -9.79709921854E-01 -1.00715883793E+00 -1.03516943082E+00 -1.06373917325E+00 -1.09286427070E+00 -1.12253955212E+00 -1.15275835238E+00 -1.18351238561E+00 -1.21479160891E+00 -1.24658407549E+00 -1.27887577653E+00 -1.31165047094E+00 -1.34488950217E+00 -1.37857160112E+00 -1.41267267459E+00 -1.44716557821E+00 -1.48201987333E+00 -1.51720156723E+00 -1.55267283623E+00 -1.58839173159E+00 -1.62431186809E+00 -1.66038209615E+00 -1.69654615803E+00 -1.73274232996E+00 -1.76890305242E+00 -1.80495455160E+00 -1.84081645636E+00 -1.87640141601E+00 -1.91161472574E+00 -1.94635396815E+00 -1.98050868122E+00 -2.01396006499E+00 -2.04658074173E+00 -2.07823458675E+00 -2.10877664967E+00 -2.13805318884E+00 -2.16590184452E+00 -2.19215197884E+00 -2.21662521373E+00 -2.23913619966E+00 -2.25949364974E+00 -2.27750167447E+00 -2.29296145140E+00 -2.30567326166E+00 -2.31543892023E+00 -2.32206461939E+00 -2.32536419304E+00 -2.32516279400E+00 -2.32130095559E+00 -2.31363898173E+00 -2.30206157647E+00 -2.28648258338E+00 -2.26684965697E+00 -2.24314863362E+00 -2.21540730815E+00 -2.18369825697E+00 -2.14814028316E+00 -2.10889799759E+00 -2.06617900171E+00 -2.02022811227E+00 -1.97131808059E+00 -1.91973632748E+00 -1.86576736302E+00 -1.80967081569E+00 -1.75165538980E+00 -1.69184963685E+00 -1.63027119738E+00 -1.56679716634E+00 -1.50113945803E+00 -1.43283045444E+00 -1.36122570100E+00 -1.28553173405E+00 -1.20486786261E+00 -1.11837016841E+00 -1.02534296858E+00 -9.25455673236E-01 -8.18968545639E-01 -7.06945069563E-01 -5.91365094273E-01 -4.74982301716E-01 -3.60676227761E-01 -2.50437062914E-01 -1.46057741310E-01 -4.95705325476E-02 3.67803698344E-02 1.10638874267E-01 1.69697731838E-01 2.11927449295E-01 2.35873604623E-01 2.41009840890E-01 2.28112689922E-01 1.99592739422E-01 1.59674078401E-01 1.14265986293E-01 7.03366261639E-02 3.46232094204E-02 1.16850314858E-02 1.77592680217E-03 1.17942184367E-05 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 -2.76918211395E+01 1.34810144270E+02 -5.93343841742E+02 2.92749263302E+03 -9.33120408621E+03 1.62987214179E+04 -1.44398162080E+04 5.09624413523E+03 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 -5.83226772897E+01 -1.18570802784E+03 1.68857558548E+04 -9.04395534470E+04 2.53490433443E+05 -3.91179886130E+05 3.14528493799E+05 -1.03052371631E+05 4 4 1 i j (l(j)) 4.07288726916E-01 Q_int 0.00000000000E+00 1.05565607995E-09 4.29511263866E-09 9.83037263488E-09 1.77779282639E-08 2.82589264679E-08 4.13993403359E-08 5.73301465999E-08 7.61875094408E-08 9.81129708242E-08 1.23253647595E-07 1.51762435567E-07 1.83798220852E-07 2.19526098683E-07 2.59117599987E-07 3.02750925994E-07 3.50611191137E-07 4.02890674562E-07 4.59789080522E-07 5.21513807991E-07 5.88280229790E-07 6.60311981588E-07 7.37841261099E-07 8.21109137838E-07 9.10365873815E-07 1.00587125553E-06 1.10789493766E-06 1.21671679891E-06 1.33262731030E-06 1.45592791656E-06 1.58693143078E-06 1.72596244310E-06 1.87335774370E-06 2.02946676066E-06 2.19465201325E-06 2.36928958107E-06 2.55376958981E-06 2.74849671388E-06 2.95389069687E-06 3.17038689014E-06 3.39843681036E-06 3.63850871660E-06 3.89108820765E-06 4.15667884029E-06 4.43580276917E-06 4.72900140920E-06 5.03683612103E-06 5.35988892060E-06 5.69876321353E-06 6.05408455516E-06 6.42650143719E-06 6.81668610187E-06 7.22533538465E-06 7.65317158620E-06 8.10094337504E-06 8.56942672164E-06 9.05942586509E-06 9.57177431366E-06 1.01073358802E-05 1.06670057536E-05 1.12517116081E-05 1.18624147504E-05 1.25001113079E-05 1.31658334575E-05 1.38606506975E-05 1.45856711643E-05 1.53420429943E-05 1.61309557335E-05 1.69536417967E-05 1.78113779766E-05 1.87054870063E-05 1.96373391757E-05 2.06083540047E-05 2.16200019738E-05 2.26738063158E-05 2.37713448692E-05 2.49142519967E-05 2.61042205698E-05 2.73430040228E-05 2.86324184781E-05 2.99743449454E-05 3.13707315977E-05 3.28235961255E-05 3.43350281737E-05 3.59071918629E-05 3.75423283981E-05 3.92427587683E-05 4.10108865395E-05 4.28492007450E-05 4.47602788757E-05 4.67467899749E-05 4.88114978396E-05 5.09572643335E-05 5.31870528147E-05 5.55039316824E-05 5.79110780468E-05 6.04117815259E-05 6.30094481742E-05 6.57076045475E-05 6.85099019090E-05 7.14201205805E-05 7.44421744453E-05 7.75801156060E-05 8.08381392049E-05 8.42205884106E-05 8.77319595774E-05 9.13769075840E-05 9.51602513562E-05 9.90869795815E-05 1.03162256621E-04 1.07391428628E-04 1.11780029872E-04 1.16333789293E-04 1.21058637270E-04 1.25960712632E-04 1.31046369910E-04 1.36322186834E-04 1.41794972101E-04 1.47471773401E-04 1.53359885722E-04 1.59466859950E-04 1.65800511755E-04 1.72368930794E-04 1.79180490225E-04 1.86243856551E-04 1.93567999813E-04 2.01162204117E-04 2.09036078542E-04 2.17199568419E-04 2.25662966990E-04 2.34436927487E-04 2.43532475613E-04 2.52961022461E-04 2.62734377876E-04 2.72864764280E-04 2.83364830973E-04 2.94247668927E-04 3.05526826088E-04 3.17216323210E-04 3.29330670233E-04 3.41884883222E-04 3.54894501897E-04 3.68375607758E-04 3.82344842841E-04 3.96819429118E-04 4.11817188564E-04 4.27356563915E-04 4.43456640144E-04 4.60137166669E-04 4.77418580330E-04 4.95322029156E-04 5.13869396950E-04 5.33083328715E-04 5.52987256957E-04 5.73605428891E-04 5.94962934587E-04 6.17085736071E-04 6.40000697437E-04 6.63735615984E-04 6.88319254429E-04 7.13781374218E-04 7.40152769987E-04 7.67465305196E-04 7.95751948991E-04 8.25046814329E-04 8.55385197404E-04 8.86803618429E-04 9.19339863806E-04 9.53033029752E-04 9.87923567403E-04 1.02405332947E-03 1.06146561849E-03 1.10020523670E-03 1.14031853768E-03 1.18185347967E-03 1.22485968079E-03 1.26938847605E-03 1.31549297643E-03 1.36322812986E-03 1.41265078431E-03 1.46381975306E-03 1.51679588215E-03 1.57164212015E-03 1.62842359029E-03 1.68720766503E-03 1.74806404317E-03 1.81106482962E-03 1.87628461775E-03 1.94380057468E-03 2.01369252935E-03 2.08604306365E-03 2.16093760651E-03 2.23846453132E-03 2.31871525652E-03 2.40178434964E-03 2.48776963481E-03 2.57677230394E-03 2.66889703158E-03 2.76425209365E-03 2.86294949022E-03 2.96510507230E-03 3.07083867298E-03 3.18027424286E-03 3.29353999013E-03 3.41076852515E-03 3.53209701004E-03 3.65766731312E-03 3.78762616853E-03 3.92212534115E-03 4.06132179698E-03 4.20537787916E-03 4.35446148985E-03 4.50874627804E-03 4.66841183358E-03 4.83364388764E-03 5.00463451969E-03 5.18158237125E-03 5.36469286676E-03 5.55417844145E-03 5.75025877688E-03 5.95316104390E-03 6.16312015368E-03 6.38037901676E-03 6.60518881050E-03 6.83780925514E-03 7.07850889872E-03 7.32756541114E-03 7.58526588760E-03 7.85190716175E-03 8.12779612869E-03 8.41325007832E-03 8.70859703912E-03 9.01417613276E-03 9.33033793985E-03 9.65744487704E-03 9.99587158596E-03 1.03460053341E-02 1.07082464281E-02 1.10830086397E-02 1.14707196449E-02 1.18718214758E-02 1.22867709875E-02 1.27160403374E-02 1.31601174798E-02 1.36195066754E-02 1.40947290153E-02 1.45863229606E-02 1.50948448979E-02 1.56208697108E-02 1.61649913679E-02 1.67278235276E-02 1.73100001602E-02 1.79121761870E-02 1.85350281380E-02 1.91792548267E-02 1.98455780449E-02 2.05347432744E-02 2.12475204194E-02 2.19847045574E-02 2.27471167099E-02 2.35356046331E-02 2.43510436289E-02 2.51943373754E-02 2.60664187794E-02 2.69682508479E-02 2.79008275818E-02 2.88651748902E-02 2.98623515247E-02 3.08934500365E-02 3.19595977530E-02 3.30619577758E-02 3.42017300002E-02 3.53801521539E-02 3.65985008578E-02 3.78580927055E-02 3.91602853634E-02 4.05064786893E-02 4.18981158706E-02 4.33366845798E-02 4.48237181476E-02 4.63607967526E-02 4.79495486260E-02 4.95916512716E-02 5.12888326979E-02 5.30428726627E-02 5.48556039275E-02 5.67289135210E-02 5.86647440087E-02 6.06650947671E-02 6.27320232606E-02 6.48676463183E-02 6.70741414067E-02 6.93537478982E-02 7.17087683292E-02 7.41415696462E-02 7.66545844347E-02 7.92503121289E-02 8.19313201943E-02 8.47002452827E-02 8.75597943503E-02 9.05127457363E-02 9.35619501944E-02 9.67103318714E-02 9.99608892264E-02 1.03316695882E-01 1.06780901400E-01 1.10356731977E-01 1.14047491041E-01 1.17856559755E-01 1.21787397400E-01 1.25843541640E-01 1.30028608655E-01 1.34346293119E-01 1.38800368033E-01 1.43394684368E-01 1.48133170543E-01 1.53019831679E-01 1.58058748652E-01 1.63254076908E-01 1.68610045019E-01 1.74130952984E-01 1.79821170225E-01 1.85685133290E-01 1.91727343211E-01 1.97952362525E-01 2.04364811909E-01 2.10969366423E-01 2.17770751331E-01 2.24773737468E-01 2.31983136141E-01 2.39403793516E-01 2.47040584488E-01 2.54898405978E-01 2.62982169647E-01 2.71296793987E-01 2.79847195754E-01 2.88638280722E-01 2.97674933702E-01 3.06962007820E-01 3.16504312991E-01 3.26306603563E-01 3.36373565103E-01 3.46709800262E-01 3.57319813697E-01 3.68207996006E-01 3.79378606622E-01 3.90835755630E-01 4.02583384457E-01 4.14625245387E-01 4.26964879842E-01 4.39605595384E-01 4.52550441372E-01 4.65802183211E-01 4.79363275134E-01 4.93235831428E-01 5.07421596035E-01 5.21921910446E-01 5.36737679767E-01 5.51869336874E-01 5.67316804525E-01 5.83079455297E-01 5.99156069193E-01 6.15544788765E-01 6.32243071539E-01 6.49247639558E-01 6.66554425784E-01 6.84158517089E-01 7.02054093555E-01 7.20234363729E-01 7.38691495459E-01 7.57416541916E-01 7.76399362318E-01 7.95628536875E-01 8.15091275393E-01 8.34773318945E-01 8.54658833975E-01 8.74730298138E-01 8.94968377177E-01 9.15351792072E-01 9.35857175713E-01 9.56458918325E-01 9.77129000915E-01 9.97836816046E-01 1.01854897533E+00 1.03922910320E+00 1.05983761659E+00 1.08033149060E+00 1.10066401033E+00 1.12078450969E+00 1.14063809832E+00 1.16016537861E+00 1.17930215557E+00 1.19797914307E+00 1.21612167148E+00 1.23364940275E+00 1.25047606084E+00 1.26650918704E+00 1.28164993185E+00 1.29579289743E+00 1.30882604715E+00 1.32063070152E+00 1.33108164286E+00 1.34004735388E+00 1.34739041864E+00 1.35296811734E+00 1.35663324870E+00 1.35823521646E+00 1.35762141713E+00 1.35463896685E+00 1.34913680342E+00 1.34096819591E+00 1.32999368780E+00 1.31608448954E+00 1.29912632214E+00 1.27902369344E+00 1.25570456337E+00 1.22912532127E+00 1.19927595790E+00 1.16618526555E+00 1.12992584190E+00 1.09061860759E+00 1.04843647426E+00 1.00360672312E+00 9.56411576695E-01 9.07186375949E-01 8.56314720438E-01 8.04219903998E-01 7.51352000001E-01 6.98170041229E-01 6.45118928160E-01 5.92601019316E-01 5.40942846798E-01 4.90358099385E-01 4.40908962002E-01 3.92469119808E-01 3.44693226567E-01 2.96999348671E-01 2.48572689021E-01 1.98400483601E-01 1.45348833174E-01 8.82915093772E-02 2.62970418989E-02 -4.11285771978E-02 -1.13763873817E-01 -1.90410343254E-01 -2.68752205588E-01 -3.45528261132E-01 -4.17326770168E-01 -4.81807156962E-01 -5.36988027851E-01 -5.80754293542E-01 -6.10937199682E-01 -6.25472067273E-01 -6.22616762630E-01 -6.01230690735E-01 -5.61103522243E-01 -5.03306395715E-01 -4.30514394717E-01 -3.47216855503E-01 -2.59693388059E-01 -1.75596964449E-01 -1.02973586657E-01 -4.86090737214E-02 -1.58178184966E-02 -2.32864446518E-03 -1.50225318952E-05 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2.11685660542E+01 -1.37526255522E+02 7.15258238975E+02 -3.55948615620E+03 1.12513540467E+04 -1.96157992825E+04 1.73949645861E+04 -6.14900452105E+03 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2.41732725852E+01 9.22573149682E+02 -1.23382853152E+04 6.55239548199E+04 -1.83003573827E+05 2.81615808489E+05 -2.25862251903E+05 7.38340640193E+04 2S 0 2.00 Wavefunction 0.00000000000E+00 7.03431067921E-06 1.41888630776E-05 2.14657125644E-05 2.88669496376E-05 3.63947005297E-05 4.40511278179E-05 5.18384310456E-05 5.97588473545E-05 6.78146521271E-05 7.60081596403E-05 8.43417237304E-05 9.28177384693E-05 1.01438638852E-04 1.10206901497E-04 1.19125045356E-04 1.28195632440E-04 1.37421268554E-04 1.46804604043E-04 1.56348334559E-04 1.66055201832E-04 1.75927994457E-04 1.85969548697E-04 1.96182749295E-04 2.06570530308E-04 2.17135875944E-04 2.27881821423E-04 2.38811453848E-04 2.49927913091E-04 2.61234392697E-04 2.72734140797E-04 2.84430461050E-04 2.96326713581E-04 3.08426315954E-04 3.20732744151E-04 3.33249533573E-04 3.45980280051E-04 3.58928640884E-04 3.72098335885E-04 3.85493148455E-04 3.99116926665E-04 4.12973584363E-04 4.27067102301E-04 4.41401529275E-04 4.55980983290E-04 4.70809652743E-04 4.85891797623E-04 5.01231750743E-04 5.16833918974E-04 5.32702784521E-04 5.48842906202E-04 5.65258920765E-04 5.81955544215E-04 5.98937573171E-04 6.16209886244E-04 6.33777445438E-04 6.51645297576E-04 6.69818575749E-04 6.88302500790E-04 7.07102382778E-04 7.26223622558E-04 7.45671713295E-04 7.65452242055E-04 7.85570891404E-04 8.06033441046E-04 8.26845769479E-04 8.48013855688E-04 8.69543780859E-04 8.91441730129E-04 9.13713994362E-04 9.36366971952E-04 9.59407170670E-04 9.82841209526E-04 1.00667582067E-03 1.03091785134E-03 1.05557426580E-03 1.08065214738E-03 1.10615870047E-03 1.13210125262E-03 1.15848725664E-03 1.18532429273E-03 1.21262007065E-03 1.24038243197E-03 1.26861935229E-03 1.29733894355E-03 1.32654945634E-03 1.35625928229E-03 1.38647695647E-03 1.41721115986E-03 1.44847072182E-03 1.48026462262E-03 1.51260199607E-03 1.54549213209E-03 1.57894447939E-03 1.61296864821E-03 1.64757441306E-03 1.68277171554E-03 1.71857066718E-03 1.75498155234E-03 1.79201483120E-03 1.82968114274E-03 1.86799130780E-03 1.90695633218E-03 1.94658740981E-03 1.98689592598E-03 2.02789346058E-03 2.06959179145E-03 2.11200289778E-03 2.15513896348E-03 2.19901238078E-03 2.24363575372E-03 2.28902190177E-03 2.33518386356E-03 2.38213490060E-03 2.42988850108E-03 2.47845838375E-03 2.52785850187E-03 2.57810304723E-03 2.62920645418E-03 2.68118340384E-03 2.73404882828E-03 2.78781791479E-03 2.84250611031E-03 2.89812912580E-03 2.95470294079E-03 3.01224380796E-03 3.07076825782E-03 3.13029310344E-03 3.19083544530E-03 3.25241267619E-03 3.31504248621E-03 3.37874286786E-03 3.44353212120E-03 3.50942885910E-03 3.57645201263E-03 3.64462083644E-03 3.71395491432E-03 3.78447416483E-03 3.85619884704E-03 3.92914956630E-03 4.00334728021E-03 4.07881330460E-03 4.15556931970E-03 4.23363737634E-03 4.31303990227E-03 4.39379970866E-03 4.47593999657E-03 4.55948436372E-03 4.64445681117E-03 4.73088175029E-03 4.81878400973E-03 4.90818884257E-03 4.99912193357E-03 5.09160940658E-03 5.18567783199E-03 5.28135423441E-03 5.37866610043E-03 5.47764138648E-03 5.57830852693E-03 5.68069644220E-03 5.78483454708E-03 5.89075275923E-03 5.99848150771E-03 6.10805174177E-03 6.21949493972E-03 6.33284311799E-03 6.44812884033E-03 6.56538522715E-03 6.68464596505E-03 6.80594531652E-03 6.92931812973E-03 7.05479984861E-03 7.18242652300E-03 7.31223481901E-03 7.44426202956E-03 7.57854608511E-03 7.71512556454E-03 7.85403970627E-03 7.99532841948E-03 8.13903229565E-03 8.28519262018E-03 8.43385138426E-03 8.58505129694E-03 8.73883579744E-03 8.89524906757E-03 9.05433604450E-03 9.21614243363E-03 9.38071472171E-03 9.54810019028E-03 9.71834692918E-03 9.89150385041E-03 1.00676207022E-02 1.02467480833E-02 1.04289374574E-02 1.06142411683E-02 1.08027124545E-02 1.09944054648E-02 1.11893752737E-02 1.13876778973E-02 1.15893703096E-02 1.17945104585E-02 1.20031572827E-02 1.22153707286E-02 1.24312117676E-02 1.26507424136E-02 1.28740257406E-02 1.31011259014E-02 1.33321081452E-02 1.35670388373E-02 1.38059854776E-02 1.40490167199E-02 1.42962023923E-02 1.45476135167E-02 1.48033223293E-02 1.50634023016E-02 1.53279281613E-02 1.55969759142E-02 1.58706228655E-02 1.61489476424E-02 1.64320302166E-02 1.67199519274E-02 1.70127955050E-02 1.73106450943E-02 1.76135862793E-02 1.79217061075E-02 1.82350931149E-02 1.85538373519E-02 1.88780304085E-02 1.92077654415E-02 1.95431372005E-02 1.98842420560E-02 2.02311780262E-02 2.05840448060E-02 2.09429437954E-02 2.13079781286E-02 2.16792527036E-02 2.20568742130E-02 2.24409511738E-02 2.28315939594E-02 2.32289148311E-02 2.36330279704E-02 2.40440495116E-02 2.44620975760E-02 2.48872923051E-02 2.53197558955E-02 2.57596126345E-02 2.62069889349E-02 2.66620133726E-02 2.71248167226E-02 2.75955319972E-02 2.80742944841E-02 2.85612417857E-02 2.90565138580E-02 2.95602530516E-02 3.00726041525E-02 3.05937144235E-02 3.11237336469E-02 3.16628141675E-02 3.22111109363E-02 3.27687815555E-02 3.33359863235E-02 3.39128882811E-02 3.44996532584E-02 3.50964499227E-02 3.57034498267E-02 3.63208274580E-02 3.69487602893E-02 3.75874288292E-02 3.82370166744E-02 3.88977105621E-02 3.95697004239E-02 4.02531794400E-02 4.09483440950E-02 4.16553942340E-02 4.23745331199E-02 4.31059674917E-02 4.38499076239E-02 4.46065673860E-02 4.53761643047E-02 4.61589196250E-02 4.69550583740E-02 4.77648094250E-02 4.85884055626E-02 4.94260835489E-02 5.02780841911E-02 5.11446524097E-02 5.20260373079E-02 5.29224922422E-02 5.38342748941E-02 5.47616473430E-02 5.57048761394E-02 5.66642323805E-02 5.76399917862E-02 5.86324347757E-02 5.96418465465E-02 6.06685171534E-02 6.17127415891E-02 6.27748198660E-02 6.38550570985E-02 6.49537635873E-02 6.60712549044E-02 6.72078519783E-02 6.83638811822E-02 6.95396744211E-02 7.07355692213E-02 7.19519088208E-02 7.31890422596E-02 7.44473244724E-02 7.57271163808E-02 7.70287849876E-02 7.83527034706E-02 7.96992512782E-02 8.10688142250E-02 8.24617845883E-02 8.38785612048E-02 8.53195495680E-02 8.67851619258E-02 8.82758173782E-02 8.97919419752E-02 9.13339688144E-02 9.29023381388E-02 9.44974974340E-02 9.61199015245E-02 9.77700126700E-02 9.94483006601E-02 1.01155242908E-01 1.02891324544E-01 1.04657038504E-01 1.06452885619E-01 1.08279374704E-01 1.10137022637E-01 1.12026354445E-01 1.13947903377E-01 1.15902210980E-01 1.17889827166E-01 1.19911310281E-01 1.21967227158E-01 1.24058153176E-01 1.26184672303E-01 1.28347377138E-01 1.30546868941E-01 1.32783757658E-01 1.35058661934E-01 1.37372209119E-01 1.39725035255E-01 1.42117785066E-01 1.44551111917E-01 1.47025677772E-01 1.49542153133E-01 1.52101216961E-01 1.54703556581E-01 1.57349867569E-01 1.60040853617E-01 1.62777226376E-01 1.65559705282E-01 1.68389017347E-01 1.71265896937E-01 1.74191085507E-01 1.77165331325E-01 1.80189389147E-01 1.83264019875E-01 1.86389990170E-01 1.89568072034E-01 1.92799042356E-01 1.96083682416E-01 1.99422777350E-01 2.02817115572E-01 2.06267488154E-01 2.09774688162E-01 2.13339509944E-01 2.16962748372E-01 2.20645198044E-01 2.24387652423E-01 2.28190902946E-01 2.32055738077E-01 2.35982942309E-01 2.39973295135E-01 2.44027569959E-01 2.48146532979E-01 2.52330942027E-01 2.56581545372E-01 2.60899080497E-01 2.65284272849E-01 2.69737834570E-01 2.74260463223E-01 2.78852840502E-01 2.83515630957E-01 2.88249480734E-01 2.93055016333E-01 2.97932843417E-01 3.02883545656E-01 3.07907683651E-01 3.13005793919E-01 3.18178387987E-01 3.23425951575E-01 3.28748943913E-01 3.34147797180E-01 3.39622916092E-01 3.45174677645E-01 3.50803431010E-01 3.56509497597E-01 3.62293171273E-01 3.68154718734E-01 3.74094380005E-01 3.80112369047E-01 3.86208874431E-01 3.92384060022E-01 3.98638065616E-01 4.04971007425E-01 4.11382978315E-01 4.17874047662E-01 4.24444260654E-01 4.31093636866E-01 4.37822167875E-01 4.44629813647E-01 4.51516497429E-01 4.58482098781E-01 4.65526444397E-01 4.72649296300E-01 4.79850336972E-01 4.87129150943E-01 4.94485202355E-01 5.01917808004E-01 5.09426105365E-01 5.17009015147E-01 5.24665197982E-01 5.32393004927E-01 5.40190421617E-01 5.48055006072E-01 5.55983820431E-01 5.63973357150E-01 5.72019460668E-01 5.80117245940E-01 5.88261015865E-01 5.96444180277E-01 6.04659179900E-01 6.12897419554E-01 6.21149215718E-01 6.29403764556E-01 6.37649137318E-01 6.45872310878E-01 6.54059241700E-01 6.62194991734E-01 6.70263914446E-01 6.78249908031E-01 6.86136740757E-01 6.93908449758E-01 7.01549809302E-01 7.09046857000E-01 7.16387456284E-01 7.23561860404E-01 7.30563227004E-01 7.37388013173E-01 7.44036159476E-01 7.50510949496E-01 7.56818411956E-01 7.62966120985E-01 7.68961255176E-01 7.74807811528E-01 7.80502957004E-01 7.86032669420E-01 7.91367116312E-01 7.96456710116E-01 8.01230566336E-01 8.05600296499E-01 8.09473894276E-01 8.12786316003E-01 8.15520073436E-01 8.17670784727E-01 8.19235250786E-01 8.20211220657E-01 8.20597465323E-01 8.20393788563E-01 8.19601034267E-01 8.18221090812E-01 8.16256891897E-01 8.13712414535E-01 8.10592673545E-01 8.06903713335E-01 8.02652596264E-01 7.97847388453E-01 7.92497142293E-01 7.86611876590E-01 7.80202553554E-01 7.73281053631E-01 7.65860147366E-01 7.57953465330E-01 7.49575465288E-01 7.40741397660E-01 7.31467268467E-01 7.21769800786E-01 7.11666393952E-01 7.01175081491E-01 6.90314487052E-01 6.79103779277E-01 6.67562624940E-01 6.55711141201E-01 6.43569846385E-01 6.31159610036E-01 6.18501601748E-01 6.05617239420E-01 5.92528136511E-01 5.79256048871E-01 5.65822820814E-01 5.52250330899E-01 5.38560437231E-01 5.24774922635E-01 5.10915439662E-01 4.97003455695E-01 4.83060198271E-01 4.69106600808E-01 4.55163249012E-01 4.41250328117E-01 4.27387571346E-01 4.13594209730E-01 3.99888923794E-01 3.86289797178E-01 3.72814272827E-01 3.59479111736E-01 3.46300354936E-01 3.33293288622E-01 3.20472413124E-01 3.07851415500E-01 2.95443146408E-01 2.83259600923E-01 2.71311903871E-01 2.59610299217E-01 2.48164143969E-01 2.36981906041E-01 2.26071166405E-01 2.15438624901E-01 2.05090109920E-01 1.95030591285E-01 1.85264196471E-01 1.75794229441E-01 1.66623192219E-01 1.57752808470E-01 1.49184049184E-01 1.40917159797E-01 1.32951688801E-01 1.25286517286E-01 1.17919889450E-01 1.10849443604E-01 1.04072243732E-01 9.75848112129E-02 9.13831567927E-02 8.54628124894E-02 7.98188635393E-02 7.44459801427E-02 6.93384491262E-02 6.44902053415E-02 5.98948629136E-02 5.55457462045E-02 5.14359205908E-02 4.75582229446E-02 4.39052918925E-02 4.04695977491E-02 3.72434721643E-02 3.42191373765E-02 3.13887350717E-02 2.87443547267E-02 2.62780613984E-02 2.39819228248E-02 2.18480357668E-02 1.98685514471E-02 1.80356999963E-02 1.63418137629E-02 1.47793493890E-02 1.33409085213E-02 1.20192570670E-02 1.08073428863E-02 9.69831185101E-03 8.68552219202E-03 7.76255709476E-03 6.92323550238E-03 6.16162111855E-03 5.47202960971E-03 4.84903403277E-03 4.28746852536E-03 3.78243031727E-03 3.32928013218E-03 2.92364106614E-03 2.56139603750E-03 2.23868391536E-03 1.95189443942E-03 1.69766205124E-03 1.47285875987E-03 1.27458616758E-03 1.10016678076E-03 9.47134730516E-04 8.13226023667E-04 6.96368441367E-04 5.94671196339E-04 5.06414453813E-04 4.30038813567E-04 3.64134842776E-04 3.07432740779E-04 2.58792208294E-04 2.17192584634E-04 1.81723307717E-04 1.51574742823E-04 1.26029417664E-04 1.04453693112E-04 8.62898912917E-05 7.10488955112E-05 5.83032299162E-05 4.76806206981E-05 3.88580353240E-05 3.15561915058E-05 2.55345235356E-05 2.05865901558E-05 1.65359052977E-05 1.32321707716E-05 1.05478882957E-05 8.37532707015E-06 6.62382238561E-06 5.21738036810E-06 4.09256359983E-06 3.19663635316E-06 2.48594047736E-06 1.92448266912E-06 1.48271056089E-06 1.13645674939E-06 8.66031153643E-07 6.55443227669E-07 4.91736603470E-07 3.64419622770E-07 2.64975827286E-07 1.86438673810E-07 1.23014320551E-07 6.97349989765E-08 2.21227971911E-08 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2P 1 2.00 Wavefunction 0.00000000000E+00 7.97851003537E-11 3.24618973626E-10 7.42966657056E-10 1.34363247908E-09 2.13577256842E-09 3.12890780843E-09 4.33293725210E-09 5.75815201395E-09 7.41524965558E-09 9.31534908191E-09 1.14700059662E-08 1.38912287222E-08 1.65914950426E-08 1.95837690238E-08 2.28815188968E-08 2.64987353863E-08 3.04499507191E-08 3.47502583057E-08 3.94153331162E-08 4.44614527782E-08 4.99055194184E-08 5.57650822765E-08 6.20583611169E-08 6.88042704661E-08 7.60224447056E-08 8.37332640486E-08 9.19578814330E-08 1.00718250361E-07 1.10037153720E-07 1.19938233615E-07 1.30446022257E-07 1.41585973932E-07 1.53384498094E-07 1.65868993627E-07 1.79067884306E-07 1.93010655505E-07 2.07727892193E-07 2.23251318269E-07 2.39613837267E-07 2.56849574502E-07 2.74993920684E-07 2.94083577066E-07 3.14156602174E-07 3.35252460174E-07 3.57412070932E-07 3.80677861830E-07 4.05093821397E-07 4.30705554813E-07 4.57560341357E-07 4.85707193868E-07 5.15196920284E-07 5.46082187328E-07 5.78417586431E-07 6.12259701948E-07 6.47667181764E-07 6.84700810370E-07 7.23423584477E-07 7.63900791291E-07 8.06200089501E-07 8.50391593110E-07 8.96547958178E-07 9.44744472602E-07 9.95059149020E-07 1.04757282096E-06 1.10236924235E-06 1.15953519045E-06 1.21916057246E-06 1.28133853578E-06 1.34616558206E-06 1.41374168539E-06 1.48417041443E-06 1.55755905888E-06 1.63401876034E-06 1.71366464776E-06 1.79661597750E-06 1.88299627841E-06 1.97293350179E-06 2.06656017677E-06 2.16401357087E-06 2.26543585634E-06 2.37097428214E-06 2.48078135200E-06 2.59501500861E-06 2.71383882423E-06 2.83742219793E-06 2.96594055967E-06 3.09957558147E-06 3.23851539597E-06 3.38295482245E-06 3.53309560085E-06 3.68914663383E-06 3.85132423724E-06 4.01985239932E-06 4.19496304884E-06 4.37689633261E-06 4.56590090257E-06 4.76223421286E-06 4.96616282723E-06 5.17796273701E-06 5.39791969026E-06 5.62632953217E-06 5.86349855742E-06 6.10974387462E-06 6.36539378352E-06 6.63078816515E-06 6.90627888559E-06 7.19223021371E-06 7.48901925336E-06 7.79703639054E-06 8.11668575612E-06 8.44838570448E-06 8.79256930884E-06 9.14968487369E-06 9.52019646496E-06 9.90458445858E-06 1.03033461080E-05 1.07169961314E-05 1.11460673193E-05 1.15911111627E-05 1.20526985041E-05 1.25314202096E-05 1.30278878653E-05 1.35427344975E-05 1.40766153178E-05 1.46302084939E-05 1.52042159471E-05 1.57993641774E-05 1.64164051174E-05 1.70561170152E-05 1.77193053483E-05 1.84068037687E-05 1.91194750813E-05 1.98582122553E-05 2.06239394711E-05 2.14176132035E-05 2.22402233416E-05 2.30927943485E-05 2.39763864600E-05 2.48920969254E-05 2.58410612911E-05 2.68244547280E-05 2.78434934055E-05 2.88994359124E-05 2.99935847273E-05 3.11272877392E-05 3.23019398215E-05 3.35189844591E-05 3.47799154331E-05 3.60862785624E-05 3.74396735061E-05 3.88417556280E-05 4.02942379252E-05 4.17988930238E-05 4.33575552426E-05 4.49721227288E-05 4.66445596670E-05 4.83768985642E-05 5.01712426141E-05 5.20297681425E-05 5.39547271373E-05 5.59484498654E-05 5.80133475799E-05 6.01519153211E-05 6.23667348133E-05 6.46604774618E-05 6.70359074530E-05 6.94958849615E-05 7.20433694675E-05 7.46814231886E-05 7.74132146292E-05 8.02420222533E-05 8.31712382823E-05 8.62043726244E-05 8.93450569395E-05 9.25970488426E-05 9.59642362534E-05 9.94506418946E-05 1.03060427945E-04 1.06797900853E-04 1.10667516314E-04 1.14673884422E-04 1.18821774997E-04 1.23116123090E-04 1.27562034689E-04 1.32164792608E-04 1.36929862586E-04 1.41862899595E-04 1.46969754363E-04 1.52256480116E-04 1.57729339565E-04 1.63394812113E-04 1.69259601329E-04 1.75330642665E-04 1.81615111442E-04 1.88120431108E-04 1.94854281783E-04 2.01824609091E-04 2.09039633296E-04 2.16507858758E-04 2.24238083696E-04 2.32239410304E-04 2.40521255198E-04 2.49093360229E-04 2.57965803660E-04 2.67149011728E-04 2.76653770600E-04 2.86491238734E-04 2.96672959667E-04 3.07210875235E-04 3.18117339242E-04 3.29405131601E-04 3.41087472951E-04 3.53178039771E-04 3.65690980014E-04 3.78640929264E-04 3.92043027449E-04 4.05912936119E-04 4.20266856309E-04 4.35121547009E-04 4.50494344262E-04 4.66403180905E-04 4.82866606979E-04 4.99903810837E-04 5.17534640950E-04 5.35779628468E-04 5.54660010526E-04 5.74197754347E-04 5.94415582154E-04 6.15336996919E-04 6.36986308979E-04 6.59388663551E-04 6.82570069162E-04 7.06557427042E-04 7.31378561499E-04 7.57062251305E-04 7.83638262142E-04 8.11137380125E-04 8.39591446445E-04 8.69033393169E-04 8.99497280226E-04 9.31018333630E-04 9.63632984971E-04 9.97378912205E-04 1.03229508181E-03 1.06842179233E-03 1.10580071936E-03 1.14447496197E-03 1.18448909075E-03 1.22588919737E-03 1.26872294572E-03 1.31303962487E-03 1.35889020357E-03 1.40632738672E-03 1.45540567349E-03 1.50618141752E-03 1.55871288891E-03 1.61306033829E-03 1.66928606294E-03 1.72745447508E-03 1.78763217227E-03 1.84988801014E-03 1.91429317740E-03 1.98092127325E-03 2.04984838727E-03 2.12115318180E-03 2.19491697694E-03 2.27122383824E-03 2.35016066713E-03 2.43181729413E-03 2.51628657507E-03 2.60366449016E-03 2.69405024625E-03 2.78754638212E-03 2.88425887711E-03 2.98429726299E-03 3.08777473924E-03 3.19480829184E-03 3.30551881561E-03 3.42003124024E-03 3.53847466005E-03 3.66098246761E-03 3.78769249129E-03 3.91874713683E-03 4.05429353306E-03 4.19448368179E-03 4.33947461208E-03 4.48942853879E-03 4.64451302579E-03 4.80490115359E-03 4.97077169178E-03 5.14230927616E-03 5.31970459081E-03 5.50315455500E-03 5.69286251530E-03 5.88903844264E-03 6.09189913478E-03 6.30166842388E-03 6.51857738963E-03 6.74286457769E-03 6.97477622377E-03 7.21456648327E-03 7.46249766658E-03 7.71884048014E-03 7.98387427327E-03 8.25788729090E-03 8.54117693216E-03 8.83405001488E-03 9.13682304618E-03 9.44982249895E-03 9.77338509446E-03 1.01078580910E-02 1.04535995785E-02 1.08109787794E-02 1.11803763555E-02 1.15621847208E-02 1.19568083605E-02 1.23646641556E-02 1.27861817146E-02 1.32218037093E-02 1.36719862185E-02 1.41371990757E-02 1.46179262239E-02 1.51146660753E-02 1.56279318767E-02 1.61582520809E-02 1.67061707226E-02 1.72722478005E-02 1.78570596641E-02 1.84611994056E-02 1.90852772574E-02 1.97299209935E-02 2.03957763368E-02 2.10835073709E-02 2.17937969557E-02 2.25273471493E-02 2.32848796333E-02 2.40671361430E-02 2.48748789032E-02 2.57088910676E-02 2.65699771639E-02 2.74589635439E-02 2.83766988389E-02 2.93240544211E-02 3.03019248705E-02 3.13112284496E-02 3.23529075838E-02 3.34279293511E-02 3.45372859802E-02 3.56819953577E-02 3.68631015475E-02 3.80816753215E-02 3.93388147042E-02 4.06356455333E-02 4.19733220369E-02 4.33530274307E-02 4.47759745367E-02 4.62434064265E-02 4.77565970920E-02 4.93168521460E-02 5.09255095572E-02 5.25839404221E-02 5.42935497783E-02 5.60557774637E-02 5.78720990246E-02 5.97440266788E-02 6.16731103371E-02 6.36609386891E-02 6.57091403569E-02 6.78193851222E-02 6.99933852312E-02 7.22328967812E-02 7.45397211926E-02 7.69157067703E-02 7.93627503548E-02 8.18827990663E-02 8.44778521389E-02 8.71499628452E-02 8.99012405042E-02 9.27338525678E-02 9.56500267727E-02 9.86520533469E-02 1.01742287248E-01 1.04923150415E-01 1.08197133994E-01 1.11566800514E-01 1.15034785958E-01 1.18603801677E-01 1.22276636087E-01 1.26056156067E-01 1.29945307985E-01 1.33947118226E-01 1.38064693126E-01 1.42301218179E-01 1.46659956340E-01 1.51144245296E-01 1.55757493474E-01 1.60503174609E-01 1.65384820615E-01 1.70406012530E-01 1.75570369248E-01 1.80881533749E-01 1.86343156531E-01 1.91958875903E-01 1.97732294826E-01 2.03666953960E-01 2.09766300590E-01 2.16033653113E-01 2.22472160804E-01 2.29084758608E-01 2.35874116770E-01 2.42842585199E-01 2.49992132559E-01 2.57324280207E-01 2.64840031281E-01 2.72539795416E-01 2.80423309812E-01 2.88489557668E-01 2.96736685289E-01 3.05161919561E-01 3.13761487885E-01 3.22530543100E-01 3.31463096420E-01 3.40551961872E-01 3.49788716264E-01 3.59163679149E-01 3.68665917726E-01 3.78283281915E-01 3.88002475092E-01 3.97809165936E-01 4.07688146590E-01 4.17623541701E-01 4.27599071788E-01 4.37598372749E-01 4.47605370916E-01 4.57604709895E-01 4.67582221297E-01 4.77525426296E-01 4.87424048685E-01 4.97270512717E-01 5.07060390629E-01 5.16792755591E-01 5.26470386258E-01 5.36099759946E-01 5.45690763539E-01 5.55256046216E-01 5.64809937737E-01 5.74366863063E-01 5.83939201647E-01 5.93534571731E-01 6.03152570950E-01 6.12781079041E-01 6.22392331101E-01 6.31939103448E-01 6.41351518631E-01 6.50535165120E-01 6.59371423641E-01 6.67721061077E-01 6.75432231242E-01 6.82353902049E-01 6.88355236302E-01 6.93350312286E-01 6.97325352864E-01 7.00361715954E-01 7.02641288565E-01 7.04410233793E-01 7.05863613679E-01 7.07041905336E-01 7.07941705140E-01 7.08559256957E-01 7.08891402438E-01 7.08935360890E-01 7.08688737178E-01 7.08149528215E-01 7.07316128646E-01 7.06187335171E-01 7.04762350149E-01 7.03040783895E-01 7.01022656366E-01 6.98708397580E-01 6.96098847533E-01 6.93195254897E-01 6.89999275319E-01 6.86512968561E-01 6.82738795320E-01 6.78679612976E-01 6.74338671088E-01 6.69719605887E-01 6.64826434599E-01 6.59663548820E-01 6.54235707787E-01 6.48548030757E-01 6.42605989311E-01 6.36415398821E-01 6.29982409836E-01 6.23313498669E-01 6.16415457858E-01 6.09295385842E-01 6.01960676429E-01 5.94419007454E-01 5.86678329120E-01 5.78746851467E-01 5.70633031377E-01 5.62345558640E-01 5.53893341366E-01 5.45285490400E-01 5.36531302895E-01 5.27640244838E-01 5.18621932595E-01 5.09486113394E-01 5.00242644769E-01 4.90901473012E-01 4.81472610626E-01 4.71966112990E-01 4.62392054177E-01 4.52760502324E-01 4.43081494466E-01 4.33365011364E-01 4.23620952234E-01 4.13859110023E-01 4.04089147079E-01 3.94320571969E-01 3.84562717205E-01 3.74824718678E-01 3.65115496467E-01 3.55443737808E-01 3.45817881796E-01 3.36246106538E-01 3.26736318232E-01 3.17296142793E-01 3.07932919424E-01 2.98653696635E-01 2.89465230027E-01 2.80373982268E-01 2.71386124492E-01 2.62507539489E-01 2.53743825876E-01 2.45100303554E-01 2.36582019655E-01 2.28193755220E-01 2.19940031866E-01 2.11825118653E-01 2.03853038468E-01 1.96027574137E-01 1.88352273667E-01 1.80830454848E-01 1.73465208706E-01 1.66259402083E-01 1.59215678939E-01 1.52336460686E-01 1.45623945277E-01 1.39080105393E-01 1.32706685560E-01 1.26505198590E-01 1.20476921251E-01 1.14622889603E-01 1.08943893973E-01 1.03440473999E-01 9.81129137876E-02 9.29612375635E-02 8.79852058931E-02 8.31843128119E-02 7.85577839253E-02 7.41045757487E-02 6.98233763280E-02 6.57126073276E-02 6.17704275832E-02 5.79947382292E-02 5.43831893451E-02 5.09331881572E-02 4.76419086952E-02 4.45063028716E-02 4.15231128490E-02 3.86888846107E-02 3.59999825739E-02 3.34526051264E-02 3.10428009125E-02 2.87664857277E-02 2.66194598487E-02 2.45974256502E-02 2.26960053433E-02 2.09107586929E-02 1.92372005631E-02 1.76708181620E-02 1.62070878554E-02 1.48414914404E-02 1.35695317704E-02 1.23867476462E-02 1.12887278901E-02 1.02711245391E-02 9.32966510056E-03 8.46016382966E-03 7.65853199522E-03 6.92078711484E-03 6.24306114816E-03 5.62160764854E-03 5.05280788118E-03 4.53317592503E-03 4.05936278257E-03 3.62815952905E-03 3.23649953846E-03 2.88145982864E-03 2.56026157297E-03 2.27026982925E-03 2.00899253974E-03 1.77407885863E-03 1.56331686467E-03 1.37463071794E-03 1.20607731985E-03 1.05584253547E-03 9.22237036494E-04 8.03691822025E-04 6.98753472556E-04 6.06079190731E-04 5.24431679912E-04 4.52673909025E-04 3.89763802575E-04 3.34748859264E-04 2.86760968079E-04 2.45011076058E-04 2.08783992857E-04 1.77433314367E-04 1.50376482607E-04 1.27090003496E-04 1.07104840885E-04 9.00020020025E-05 7.54083264365E-05 6.29924878222E-05 5.24612146702E-05 4.35557341871E-05 3.60484405666E-05 2.97397870652E-05 2.44553992206E-05 2.00434048400E-05 1.63719748700E-05 1.33270679548E-05 1.08103703997E-05 8.73742235521E-06 7.03592033061E-06 5.64418559616E-06 4.50978764380E-06 3.58831160481E-06 2.84225835448E-06 2.24006592878E-06 1.75524079786E-06 1.36558743227E-06 1.05252439383E-06 8.00474792768E-07 5.96318252394E-07 4.28890339618E-07 2.88513506462E-07 1.66540589030E-07 5.48873046189E-08 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 8.65281345887E-11 3.52054131970E-10 8.05758452995E-10 1.45718952596E-09 2.31627731310E-09 3.39334735996E-09 4.69913534438E-09 6.24480214273E-09 8.04194943148E-09 1.01026358427E-08 1.24393936930E-08 1.50652463061E-08 1.79937259491E-08 2.12388924054E-08 2.48153522041E-08 2.87382785315E-08 3.30234318470E-08 3.76871812273E-08 4.27465264671E-08 4.82191209588E-08 5.41232953824E-08 6.04780822306E-08 6.73032412003E-08 7.46192854799E-08 8.24475089633E-08 9.08100144241E-08 9.97297426821E-08 1.09230502798E-07 1.19337003330E-07 1.30074884693E-07 1.41470752656E-07 1.53552213012E-07 1.66347907482E-07 1.79887550860E-07 1.94201969486E-07 2.09323141049E-07 2.25284235809E-07 2.42119659246E-07 2.59865096223E-07 2.78557556686E-07 2.98235422976E-07 3.18938498794E-07 3.40708059887E-07 3.63586906505E-07 3.87619417704E-07 4.12851607542E-07 4.39331183250E-07 4.67107605439E-07 4.96232150404E-07 5.26757974629E-07 5.58740181524E-07 5.92235890515E-07 6.27304308543E-07 6.64006804060E-07 7.02406983615E-07 7.42570771114E-07 7.84566489852E-07 8.28464947406E-07 8.74339523496E-07 9.22266260911E-07 9.72323959610E-07 1.02459427411E-06 1.07916181426E-06 1.13611424955E-06 1.19554241705E-06 1.25754043309E-06 1.32220580887E-06 1.38963957011E-06 1.45994638079E-06 1.53323467129E-06 1.60961677096E-06 1.68920904533E-06 1.77213203802E-06 1.85851061771E-06 1.94847413015E-06 2.04215655547E-06 2.13969667098E-06 2.24123821965E-06 2.34693008442E-06 2.45692646859E-06 2.57138708251E-06 2.69047733669E-06 2.81436854174E-06 2.94323811517E-06 3.07726979541E-06 3.21665386328E-06 3.36158737114E-06 3.51227438004E-06 3.66892620508E-06 3.83176166931E-06 4.00100736642E-06 4.17689793265E-06 4.35967632804E-06 4.54959412748E-06 4.74691182195E-06 4.95189913007E-06 5.16483532064E-06 5.38600954625E-06 5.61572118853E-06 5.85428021538E-06 6.10200755063E-06 6.35923545645E-06 6.62630792913E-06 6.90358110858E-06 7.19142370195E-06 7.49021742208E-06 7.80035744109E-06 8.12225285974E-06 8.45632719306E-06 8.80301887282E-06 9.16278176750E-06 9.53608572019E-06 9.92341710529E-06 1.03252794044E-05 1.07421938021E-05 1.11746998030E-05 1.16233558690E-05 1.20887400802E-05 1.25714508171E-05 1.30721074681E-05 1.35913511600E-05 1.41298455151E-05 1.46882774335E-05 1.52673579038E-05 1.58678228403E-05 1.64904339509E-05 1.71359796336E-05 1.78052759054E-05 1.84991673627E-05 1.92185281747E-05 1.99642631122E-05 2.07373086116E-05 2.15386338754E-05 2.23692420114E-05 2.32301712117E-05 2.41224959715E-05 2.50473283514E-05 2.60058192829E-05 2.69991599189E-05 2.80285830318E-05 2.90953644596E-05 3.02008246023E-05 3.13463299704E-05 3.25332947867E-05 3.37631826441E-05 3.50375082211E-05 3.63578390562E-05 3.77257973847E-05 3.91430620383E-05 4.06113704120E-05 4.21325204978E-05 4.37083729904E-05 4.53408534650E-05 4.70319546315E-05 4.87837386664E-05 5.05983396266E-05 5.24779659461E-05 5.44249030199E-05 5.64415158783E-05 5.85302519534E-05 6.06936439421E-05 6.29343127686E-05 6.52549706505E-05 6.76584242709E-05 7.01475780614E-05 7.27254375990E-05 7.53951131219E-05 7.81598231671E-05 8.10228983350E-05 8.39877851857E-05 8.70580502701E-05 9.02373843026E-05 9.35296064787E-05 9.69386689435E-05 1.00468661416E-04 1.04123815975E-04 1.07908512013E-04 1.11827281360E-04 1.15884813592E-04 1.20085961518E-04 1.24435746867E-04 1.28939366165E-04 1.33602196827E-04 1.38429803455E-04 1.43427944360E-04 1.48602578314E-04 1.53959871534E-04 1.59506204914E-04 1.65248181517E-04 1.71192634315E-04 1.77346634216E-04 1.83717498368E-04 1.90312798750E-04 1.97140371075E-04 2.04208323998E-04 2.11525048654E-04 2.19099228534E-04 2.26939849699E-04 2.35056211370E-04 2.43457936881E-04 2.52154985024E-04 2.61157661795E-04 2.70476632558E-04 2.80122934635E-04 2.90107990352E-04 3.00443620538E-04 3.11142058515E-04 3.22215964575E-04 3.33678440983E-04 3.45543047507E-04 3.57823817508E-04 3.70535274603E-04 3.83692449924E-04 3.97310899998E-04 4.11406725262E-04 4.25996589251E-04 4.41097738471E-04 4.56728022988E-04 4.72905917760E-04 4.89650544739E-04 5.06981695772E-04 5.24919856332E-04 5.43486230106E-04 5.62702764479E-04 5.82592176945E-04 6.03177982478E-04 6.24484521901E-04 6.46536991295E-04 6.69361472481E-04 6.92984964624E-04 7.17435416990E-04 7.42741762921E-04 7.68933955052E-04 7.96043001833E-04 8.24101005403E-04 8.53141200871E-04 8.83197997053E-04 9.14307018729E-04 9.46505150479E-04 9.79830582155E-04 1.01432285606E-03 1.05002291591E-03 1.08697315761E-03 1.12521748199E-03 1.16480134951E-03 1.20577183705E-03 1.24817769685E-03 1.29206941771E-03 1.33749928853E-03 1.38452146431E-03 1.43319203460E-03 1.48356909471E-03 1.53571281960E-03 1.58968554065E-03 1.64555182540E-03 1.70337856046E-03 1.76323503757E-03 1.82519304313E-03 1.88932695120E-03 1.95571382018E-03 2.02443349332E-03 2.09556870323E-03 2.16920518056E-03 2.24543176700E-03 2.32434053284E-03 2.40602689922E-03 2.49058976538E-03 2.57813164098E-03 2.66875878387E-03 2.76258134343E-03 2.85971350978E-03 2.96027366910E-03 3.06438456537E-03 3.17217346876E-03 3.28377235101E-03 3.39931806807E-03 3.51895255034E-03 3.64282300096E-03 3.77108210227E-03 3.90388823103E-03 4.04140568274E-03 4.18380490538E-03 4.33126274308E-03 4.48396269020E-03 4.64209515622E-03 4.80585774186E-03 4.97545552724E-03 5.15110137217E-03 5.33301622957E-03 5.52142947233E-03 5.71657923426E-03 5.91871276588E-03 6.12808680563E-03 6.34496796718E-03 6.56963314361E-03 6.80236992922E-03 7.04347705974E-03 7.29326487169E-03 7.55205578191E-03 7.82018478797E-03 8.09799999049E-03 8.38586313827E-03 8.68415019725E-03 8.99325194436E-03 9.31357458717E-03 9.64554041070E-03 9.98958845228E-03 1.03461752057E-02 1.07157753562E-02 1.10988825466E-02 1.14960101771E-02 1.19076922394E-02 1.23344841861E-02 1.27769638375E-02 1.32357323272E-02 1.37114150869E-02 1.42046628732E-02 1.47161528374E-02 1.52465896389E-02 1.57967066053E-02 1.63672669397E-02 1.69590649766E-02 1.75729274886E-02 1.82097150453E-02 1.88703234250E-02 1.95556850823E-02 2.02667706715E-02 2.10045906280E-02 2.17701968096E-02 2.25646841972E-02 2.33891926587E-02 2.42449087756E-02 2.51330677333E-02 2.60549552775E-02 2.70119097369E-02 2.80053241124E-02 2.90366482354E-02 3.01073909933E-02 3.12191226264E-02 3.23734770919E-02 3.35721545008E-02 3.48169236230E-02 3.61096244645E-02 3.74521709153E-02 3.88465534677E-02 4.02948420069E-02 4.17991886727E-02 4.33618307933E-02 4.49850938918E-02 4.66713947664E-02 4.84232446457E-02 5.02432524202E-02 5.21341279539E-02 5.40986854786E-02 5.61398470747E-02 5.82606462465E-02 6.04642315966E-02 6.27538706105E-02 6.51329535629E-02 6.76049975580E-02 7.01736507234E-02 7.28426965760E-02 7.56160585858E-02 7.84978049670E-02 8.14921537297E-02 8.46034780337E-02 8.78363118915E-02 9.11953562729E-02 9.46854856763E-02 9.83117552345E-02 1.02079408439E-01 1.05993885568E-01 1.10060832928E-01 1.14286113014E-01 1.18675815710E-01 1.23236270681E-01 1.27974061081E-01 1.32896038756E-01 1.38009341096E-01 1.43321409715E-01 1.48840011143E-01 1.54573259711E-01 1.60529642812E-01 1.66718048707E-01 1.73147797045E-01 1.79828672225E-01 1.86770959704E-01 1.93985485308E-01 2.01483657541E-01 2.09277512802E-01 2.17379763331E-01 2.25803847567E-01 2.34563982461E-01 2.43675217112E-01 2.53153486852E-01 2.63015666708E-01 2.73279622822E-01 2.83964260141E-01 2.95089564289E-01 3.06676635149E-01 3.18747709249E-01 3.31326167584E-01 3.44436525044E-01 3.58104397137E-01 3.72356439266E-01 3.87220253421E-01 4.02724256851E-01 4.18897507126E-01 4.35769478041E-01 4.53369781127E-01 4.71727828196E-01 4.90872431463E-01 5.10831339485E-01 5.31630709457E-01 5.53294519634E-01 5.75843929628E-01 5.99296601510E-01 6.23666000774E-01 6.48960703595E-01 6.75183745172E-01 7.02332053264E-01 7.30396020863E-01 7.59359281768E-01 7.89198761760E-01 8.19885084866E-01 8.51383417073E-01 8.83654826587E-01 9.16658227322E-01 9.50352947142E-01 9.84701920216E-01 1.01967543892E+00 1.05525531006E+00 1.09143913875E+00 1.12824430807E+00 1.16571103625E+00 1.20390368252E+00 1.24290926092E+00 1.28283194688E+00 1.32378229845E+00 1.36586008098E+00 1.40913017471E+00 1.45359235920E+00 1.49914826572E+00 1.54557315793E+00 1.59250746487E+00 1.63949464584E+00 1.68610955843E+00 1.73212877029E+00 1.77742289297E+00 1.82186409394E+00 1.86532426828E+00 1.90767550147E+00 1.94879056088E+00 1.98854341694E+00 2.02680979527E+00 2.06346776018E+00 2.09839833064E+00 2.13148612891E+00 2.16262005979E+00 2.19169401428E+00 2.21860757892E+00 2.24326670036E+00 2.26558428986E+00 2.28548070486E+00 2.30288402525E+00 2.31773005566E+00 2.32996247452E+00 2.33953392244E+00 2.34640521574E+00 2.35054691610E+00 2.35193907423E+00 2.35057137125E+00 2.34644320161E+00 2.33956370088E+00 2.32995171422E+00 2.31763570997E+00 2.30265363502E+00 2.28505271737E+00 2.26488921314E+00 2.24222810463E+00 2.21714274713E+00 2.18971447210E+00 2.16003214480E+00 2.12819168497E+00 2.09429554894E+00 2.05845218228E+00 2.02077544205E+00 1.98138399770E+00 1.94040071028E+00 1.89795199898E+00 1.85416719493E+00 1.80917789111E+00 1.76311728844E+00 1.71611954647E+00 1.66831913905E+00 1.61985022251E+00 1.57084601688E+00 1.52143820710E+00 1.47175636444E+00 1.42192739432E+00 1.37207501090E+00 1.32231924330E+00 1.27277597412E+00 1.22355651392E+00 1.17476721229E+00 1.12650910830E+00 1.07887762075E+00 1.03196228007E+00 9.85846502331E-01 9.40607406015E-01 8.96315672130E-01 8.53035447237E-01 8.10824289768E-01 7.69733158351E-01 7.29806442153E-01 6.91082031054E-01 6.53591425250E-01 6.17359881221E-01 5.82406593148E-01 5.48744905903E-01 5.16382558195E-01 4.85321951307E-01 4.55560441535E-01 4.27090651319E-01 3.99900796831E-01 3.73975026828E-01 3.49293770385E-01 3.25834088419E-01 3.03570026725E-01 2.82472965791E-01 2.62511965414E-01 2.43654100019E-01 2.25864783144E-01 2.09108077761E-01 1.93346991485E-01 1.78543754149E-01 1.64660077421E-01 1.51657394751E-01 1.39497081897E-01 1.28140657092E-01 1.17549961551E-01 1.07687320065E-01 9.85156827293E-02 8.99987480690E-02 8.21010688704E-02 7.47881413339E-02 6.80264790006E-02 6.17836722913E-02 5.60284351393E-02 5.07306396624E-02 4.58613402918E-02 4.13927883143E-02 3.72984381122E-02 3.35529459937E-02 3.01321627262E-02 2.70131205473E-02 2.41740155769E-02 2.15941862659E-02 1.92540886118E-02 1.71352686398E-02 1.52203327025E-02 1.34929159731E-02 1.19376495372E-02 1.05401263571E-02 9.28686640201E-03 8.16528113997E-03 7.16363760706E-03 6.27102219958E-03 5.47730435115E-03 4.77310021265E-03 4.14973646472E-03 3.59921436561E-03 3.11417414657E-03 2.68785984994E-03 2.31408471160E-03 1.98719717805E-03 1.70204765147E-03 1.45395604698E-03 1.23868024607E-03 1.05238552152E-03 8.91615005649E-04 7.53261264634E-04 6.34539035573E-04 5.32959173281E-04 4.46303845854E-04 3.72603007966E-04 3.10112171950E-04 2.57291486698E-04 2.12786125381E-04 1.75407973581E-04 1.44118600971E-04 1.18013491414E-04 9.63074990472E-05 7.83214911690E-05 6.34701329954E-05 5.12507643607E-05 4.12333144367E-05 3.30511973885E-05 2.63931296579E-05 2.09958081713E-05 1.66373881904E-05 1.31316996927E-05 1.03231420078E-05 8.08219787943E-06 6.30151007880E-06 4.89246608485E-06 3.78223908660E-06 2.91123656733E-06 2.23091092631E-06 1.70188990547E-06 1.29238795213E-06 9.76863004114E-07 7.34886481208E-07 5.50197461833E-07 4.09915082768E-07 3.03886083412E-07 2.24147094014E-07 1.64484141350E-07 1.20073213674E-07 8.71889179535E-08 6.29695584790E-08 4.52287557679E-08 3.23052377528E-08 2.29437529200E-08 1.62012042161E-08 1.13730969092E-08 7.93624740838E-09 5.50442756645E-09 3.79423419748E-09 2.59898984084E-09 1.76891083482E-09 1.19613309302E-09 8.03476149079E-10 5.36083118228E-10 3.55221477857E-10 2.33728214587E-10 1.52685097671E-10 9.90083490481E-11 6.37136616056E-11 4.06763688765E-11 2.57519601516E-11 1.61568649849E-11 1.00357906546E-11 6.16174047031E-12 3.72965804211E-12 2.21561518246E-12 1.28151977802E-12 7.11190910895E-13 3.67893844051E-13 1.66480085563E-13 5.54715351690E-14 6.02523237107E-15 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 TDDFPT/Examples/pseudo/Si.pbe-n-van.UPF0000644000175000017500000215031012341371476015723 0ustar mbamba Generated using Vanderbilt code, version 7 3 5 Author: unknown Generation date: 10 6 2004 Automatically converted from original format 1 The Pseudo was generated with a Scalar-Relativistic Calculation 1.70000000000E+00 Local Potential cutoff radius nl pn l occ Rcut Rcut US E pseu 3S 3 0 2.00 10.00000000000 1.70000000000 -0.79473140944 3P 3 1 2.00 10.00000000000 1.70000000000 -0.29996198285 0 Version Number Si Element US Ultrasoft pseudopotential T Nonlinear Core Correction SLA PW PBE PBE PBE Exchange-Correlation functional 4.00000000000 Z valence -9.19870184797 Total energy 0.0000000 0.0000000 Suggested cutoff for wfc and rho 2 Max angular momentum component 899 Number of points in mesh 2 6 Number of Wavefunctions, Number of Projectors Wavefunctions nl l occ 3S 0 2.00 3P 1 2.00 0.00000000000E+00 1.09467068474E-06 2.20773876668E-06 3.33951343854E-06 4.49030908945E-06 5.66044539229E-06 6.85024739243E-06 8.06004559807E-06 9.29017607207E-06 1.05409805252E-05 1.18128064113E-05 1.31060070233E-05 1.44209415922E-05 1.57579753858E-05 1.71174798111E-05 1.84998325169E-05 1.99054174990E-05 2.13346252067E-05 2.27878526514E-05 2.42655035165E-05 2.57679882704E-05 2.72957242794E-05 2.88491359245E-05 3.04286547189E-05 3.20347194281E-05 3.36677761914E-05 3.53282786462E-05 3.70166880538E-05 3.87334734278E-05 4.04791116640E-05 4.22540876731E-05 4.40588945154E-05 4.58940335378E-05 4.77600145130E-05 4.96573557809E-05 5.15865843930E-05 5.35482362585E-05 5.55428562934E-05 5.75709985716E-05 5.96332264790E-05 6.17301128700E-05 6.38622402264E-05 6.60302008196E-05 6.82345968748E-05 7.04760407384E-05 7.27551550481E-05 7.50725729059E-05 7.74289380538E-05 7.98249050529E-05 8.22611394651E-05 8.47383180376E-05 8.72571288917E-05 8.98182717131E-05 9.24224579470E-05 9.50704109951E-05 9.77628664170E-05 1.00500572134E-04 1.03284288638E-04 1.06114789202E-04 1.08992860093E-04 1.11919300794E-04 1.14894924224E-04 1.17920556965E-04 1.20997039490E-04 1.24125226396E-04 1.27305986645E-04 1.30540203801E-04 1.33828776280E-04 1.37172617594E-04 1.40572656610E-04 1.44029837805E-04 1.47545121529E-04 1.51119484273E-04 1.54753918938E-04 1.58449435113E-04 1.62207059354E-04 1.66027835469E-04 1.69912824810E-04 1.73863106565E-04 1.77879778061E-04 1.81963955065E-04 1.86116772097E-04 1.90339382744E-04 1.94632959981E-04 1.98998696495E-04 2.03437805019E-04 2.07951518668E-04 2.12541091280E-04 2.17207797766E-04 2.21952934462E-04 2.26777819494E-04 2.31683793137E-04 2.36672218194E-04 2.41744480371E-04 2.46901988662E-04 2.52146175741E-04 2.57478498361E-04 2.62900437757E-04 2.68413500057E-04 2.74019216704E-04 2.79719144877E-04 2.85514867926E-04 2.91407995811E-04 2.97400165551E-04 3.03493041675E-04 3.09688316688E-04 3.15987711539E-04 3.22392976102E-04 3.28905889658E-04 3.35528261390E-04 3.42261930889E-04 3.49108768663E-04 3.56070676655E-04 3.63149588773E-04 3.70347471426E-04 3.77666324073E-04 3.85108179776E-04 3.92675105764E-04 4.00369204011E-04 4.08192611815E-04 4.16147502395E-04 4.24236085494E-04 4.32460607994E-04 4.40823354536E-04 4.49326648159E-04 4.57972850944E-04 4.66764364669E-04 4.75703631479E-04 4.84793134561E-04 4.94035398834E-04 5.03432991654E-04 5.12988523524E-04 5.22704648819E-04 5.32584066526E-04 5.42629520991E-04 5.52843802683E-04 5.63229748968E-04 5.73790244897E-04 5.84528224010E-04 5.95446669148E-04 6.06548613281E-04 6.17837140356E-04 6.29315386147E-04 6.40986539128E-04 6.52853841363E-04 6.64920589399E-04 6.77190135190E-04 6.89665887021E-04 7.02351310459E-04 7.15249929315E-04 7.28365326621E-04 7.41701145626E-04 7.55261090812E-04 7.69048928917E-04 7.83068489985E-04 7.97323668427E-04 8.11818424108E-04 8.26556783442E-04 8.41542840512E-04 8.56780758209E-04 8.72274769385E-04 8.88029178031E-04 9.04048360475E-04 9.20336766591E-04 9.36898921041E-04 9.53739424532E-04 9.70862955088E-04 9.88274269355E-04 1.00597820392E-03 1.02397967666E-03 1.04228368810E-03 1.06089532281E-03 1.07981975079E-03 1.09906222897E-03 1.11862810259E-03 1.13852280674E-03 1.15875186787E-03 1.17932090528E-03 1.20023563273E-03 1.22150186000E-03 1.24312549451E-03 1.26511254297E-03 1.28746911303E-03 1.31020141499E-03 1.33331576353E-03 1.35681857944E-03 1.38071639145E-03 1.40501583798E-03 1.42972366903E-03 1.45484674806E-03 1.48039205385E-03 1.50636668250E-03 1.53277784933E-03 1.55963289096E-03 1.58693926729E-03 1.61470456360E-03 1.64293649266E-03 1.67164289684E-03 1.70083175034E-03 1.73051116135E-03 1.76068937435E-03 1.79137477237E-03 1.82257587933E-03 1.85430136239E-03 1.88656003441E-03 1.91936085633E-03 1.95271293969E-03 1.98662554919E-03 2.02110810521E-03 2.05617018646E-03 2.09182153263E-03 2.12807204710E-03 2.16493179969E-03 2.20241102947E-03 2.24052014756E-03 2.27926974008E-03 2.31867057106E-03 2.35873358541E-03 2.39946991203E-03 2.44089086681E-03 2.48300795584E-03 2.52583287858E-03 2.56937753112E-03 2.61365400948E-03 2.65867461296E-03 2.70445184758E-03 2.75099842953E-03 2.79832728872E-03 2.84645157234E-03 2.89538464858E-03 2.94514011027E-03 2.99573177868E-03 3.04717370738E-03 3.09948018614E-03 3.15266574486E-03 3.20674515765E-03 3.26173344692E-03 3.31764588754E-03 3.37449801112E-03 3.43230561026E-03 3.49108474302E-03 3.55085173730E-03 3.61162319544E-03 3.67341599878E-03 3.73624731238E-03 3.80013458980E-03 3.86509557792E-03 3.93114832186E-03 3.99831117004E-03 4.06660277923E-03 4.13604211978E-03 4.20664848082E-03 4.27844147569E-03 4.35144104735E-03 4.42566747394E-03 4.50114137437E-03 4.57788371411E-03 4.65591581096E-03 4.73525934101E-03 4.81593634465E-03 4.89796923266E-03 4.98138079249E-03 5.06619419455E-03 5.15243299867E-03 5.24012116063E-03 5.32928303880E-03 5.41994340096E-03 5.51212743111E-03 5.60586073654E-03 5.70116935486E-03 5.79807976131E-03 5.89661887607E-03 5.99681407175E-03 6.09869318099E-03 6.20228450420E-03 6.30761681741E-03 6.41471938028E-03 6.52362194420E-03 6.63435476059E-03 6.74694858929E-03 6.86143470706E-03 6.97784491636E-03 7.09621155409E-03 7.21656750064E-03 7.33894618900E-03 7.46338161402E-03 7.58990834191E-03 7.71856151979E-03 7.84937688548E-03 7.98239077743E-03 8.11764014480E-03 8.25516255771E-03 8.39499621773E-03 8.53717996844E-03 8.68175330624E-03 8.82875639133E-03 8.97823005882E-03 9.13021583016E-03 9.28475592458E-03 9.44189327089E-03 9.60167151936E-03 9.76413505386E-03 9.92932900420E-03 1.00972992586E-02 1.02680924767E-02 1.04417561020E-02 1.06183383755E-02 1.07978883491E-02 1.09804558988E-02 1.11660917391E-02 1.13548474367E-02 1.15467754249E-02 1.17419290183E-02 1.19403624274E-02 1.21421307740E-02 1.23472901061E-02 1.25558974136E-02 1.27680106446E-02 1.29836887205E-02 1.32029915535E-02 1.34259800623E-02 1.36527161897E-02 1.38832629193E-02 1.41176842934E-02 1.43560454307E-02 1.45984125439E-02 1.48448529589E-02 1.50954351329E-02 1.53502286738E-02 1.56093043591E-02 1.58727341559E-02 1.61405912410E-02 1.64129500207E-02 1.66898861520E-02 1.69714765635E-02 1.72577994764E-02 1.75489344269E-02 1.78449622875E-02 1.81459652901E-02 1.84520270486E-02 1.87632325822E-02 1.90796683387E-02 1.94014222192E-02 1.97285836016E-02 2.00612433664E-02 2.03994939210E-02 2.07434292263E-02 2.10931448219E-02 2.14487378533E-02 2.18103070987E-02 2.21779529964E-02 2.25517776724E-02 2.29318849694E-02 2.33183804753E-02 2.37113715523E-02 2.41109673672E-02 2.45172789214E-02 2.49304190818E-02 2.53505026123E-02 2.57776462053E-02 2.62119685147E-02 2.66535901883E-02 2.71026339017E-02 2.75592243921E-02 2.80234884931E-02 2.84955551699E-02 2.89755555554E-02 2.94636229858E-02 2.99598930388E-02 3.04645035702E-02 3.09775947530E-02 3.14993091156E-02 3.20297915823E-02 3.25691895125E-02 3.31176527425E-02 3.36753336268E-02 3.42423870803E-02 3.48189706215E-02 3.54052444161E-02 3.60013713219E-02 3.66075169334E-02 3.72238496282E-02 3.78505406140E-02 3.84877639756E-02 3.91356967235E-02 3.97945188432E-02 4.04644133451E-02 4.11455663154E-02 4.18381669675E-02 4.25424076950E-02 4.32584841248E-02 4.39865951717E-02 4.47269430934E-02 4.54797335469E-02 4.62451756454E-02 4.70234820168E-02 4.78148688621E-02 4.86195560163E-02 4.94377670086E-02 5.02697291252E-02 5.11156734720E-02 5.19758350390E-02 5.28504527654E-02 5.37397696064E-02 5.46440325999E-02 5.55634929361E-02 5.64984060265E-02 5.74490315752E-02 5.84156336509E-02 5.93984807604E-02 6.03978459232E-02 6.14140067471E-02 6.24472455055E-02 6.34978492159E-02 6.45661097193E-02 6.56523237617E-02 6.67567930761E-02 6.78798244668E-02 6.90217298940E-02 7.01828265611E-02 7.13634370025E-02 7.25638891729E-02 7.37845165391E-02 7.50256581722E-02 7.62876588415E-02 7.75708691111E-02 7.88756454364E-02 8.02023502638E-02 8.15513521307E-02 8.29230257688E-02 8.43177522071E-02 8.57359188789E-02 8.71779197282E-02 8.86441553202E-02 9.01350329520E-02 9.16509667659E-02 9.31923778642E-02 9.47596944268E-02 9.63533518293E-02 9.79737927647E-02 9.96214673658E-02 1.01296833331E-01 1.03000356049E-01 1.04732508734E-01 1.06493772548E-01 1.08284636744E-01 1.10105598796E-01 1.11957164537E-01 1.13839848304E-01 1.15754173077E-01 1.17700670624E-01 1.19679881652E-01 1.21692355954E-01 1.23738652564E-01 1.25819339912E-01 1.27934995978E-01 1.30086208459E-01 1.32273574928E-01 1.34497703000E-01 1.36759210503E-01 1.39058725649E-01 1.41396887206E-01 1.43774344679E-01 1.46191758487E-01 1.48649800151E-01 1.51149152475E-01 1.53690509740E-01 1.56274577894E-01 1.58902074752E-01 1.61573730190E-01 1.64290286352E-01 1.67052497854E-01 1.69861131996E-01 1.72716968971E-01 1.75620802085E-01 1.78573437978E-01 1.81575696846E-01 1.84628412668E-01 1.87732433441E-01 1.90888621412E-01 1.94097853321E-01 1.97361020642E-01 2.00679029831E-01 2.04052802578E-01 2.07483276065E-01 2.10971403223E-01 2.14518152999E-01 2.18124510622E-01 2.21791477884E-01 2.25520073409E-01 2.29311332942E-01 2.33166309635E-01 2.37086074341E-01 2.41071715907E-01 2.45124341482E-01 2.49245076821E-01 2.53435066600E-01 2.57695474731E-01 2.62027484690E-01 2.66432299838E-01 2.70911143766E-01 2.75465260624E-01 2.80095915474E-01 2.84804394640E-01 2.89592006063E-01 2.94460079665E-01 2.99409967720E-01 3.04443045229E-01 3.09560710301E-01 3.14764384544E-01 3.20055513455E-01 3.25435566827E-01 3.30906039153E-01 3.36468450045E-01 3.42124344651E-01 3.47875294091E-01 3.53722895888E-01 3.59668774412E-01 3.65714581335E-01 3.71861996087E-01 3.78112726322E-01 3.84468508394E-01 3.90931107840E-01 3.97502319867E-01 4.04183969855E-01 4.10977913860E-01 4.17886039132E-01 4.24910264641E-01 4.32052541603E-01 4.39314854032E-01 4.46699219284E-01 4.54207688617E-01 4.61842347766E-01 4.69605317520E-01 4.77498754308E-01 4.85524850803E-01 4.93685836527E-01 5.01983978473E-01 5.10421581735E-01 5.19000990144E-01 5.27724586926E-01 5.36594795358E-01 5.45614079443E-01 5.54784944596E-01 5.64109938339E-01 5.73591651007E-01 5.83232716472E-01 5.93035812867E-01 6.03003663340E-01 6.13139036801E-01 6.23444748697E-01 6.33923661792E-01 6.44578686962E-01 6.55412784006E-01 6.66428962464E-01 6.77630282457E-01 6.89019855534E-01 7.00600845540E-01 7.12376469489E-01 7.24349998466E-01 7.36524758526E-01 7.48904131626E-01 7.61491556560E-01 7.74290529917E-01 7.87304607048E-01 8.00537403060E-01 8.13992593813E-01 8.27673916947E-01 8.41585172918E-01 8.55730226053E-01 8.70113005624E-01 8.84737506941E-01 8.99607792458E-01 9.14727992907E-01 9.30102308440E-01 9.45735009799E-01 9.61630439503E-01 9.77793013049E-01 9.94227220146E-01 1.01093762596E+00 1.02792887237E+00 1.04520567928E+00 1.06277284592E+00 1.08063525217E+00 1.09879785991E+00 1.11726571444E+00 1.13604394584E+00 1.15513777040E+00 1.17455249208E+00 1.19429350399E+00 1.21436628987E+00 1.23477642561E+00 1.25552958085E+00 1.27663152046E+00 1.29808810625E+00 1.31990529850E+00 1.34208915770E+00 1.36464584616E+00 1.38758162978E+00 1.41090287976E+00 1.43461607437E+00 1.45872780077E+00 1.48324475680E+00 1.50817375290E+00 1.53352171394E+00 1.55929568119E+00 1.58550281425E+00 1.61215039304E+00 1.63924581985E+00 1.66679662136E+00 1.69481045073E+00 1.72329508978E+00 1.75225845108E+00 1.78170858020E+00 1.81165365792E+00 1.84210200252E+00 1.87306207205E+00 1.90454246673E+00 1.93655193134E+00 1.96909935757E+00 2.00219378661E+00 2.03584441156E+00 2.07006058002E+00 2.10485179672E+00 2.14022772610E+00 2.17619819504E+00 2.21277319556E+00 2.24996288763E+00 2.28777760194E+00 2.32622784284E+00 2.36532429119E+00 2.40507780737E+00 2.44549943428E+00 2.48660040040E+00 2.52839212294E+00 2.57088621098E+00 2.61409446869E+00 2.65802889867E+00 2.70270170518E+00 2.74812529765E+00 2.79431229401E+00 2.84127552430E+00 2.88902803415E+00 2.93758308846E+00 2.98695417505E+00 3.03715500844E+00 3.08819953361E+00 3.14010192994E+00 3.19287661510E+00 3.24653824904E+00 3.30110173814E+00 3.35658223926E+00 3.41299516401E+00 3.47035618301E+00 3.52868123025E+00 3.58798650751E+00 3.64828848885E+00 3.70960392520E+00 3.77194984904E+00 3.83534357908E+00 3.89980272508E+00 3.96534519279E+00 4.03198918887E+00 4.09975322596E+00 4.16865612785E+00 4.23871703467E+00 4.30995540824E+00 4.38239103745E+00 4.45604404378E+00 4.53093488687E+00 4.60708437021E+00 4.68451364692E+00 4.76324422564E+00 4.84329797648E+00 4.92469713710E+00 5.00746431891E+00 5.09162251332E+00 5.17719509815E+00 5.26420584412E+00 5.35267892142E+00 5.44263890650E+00 5.53411078881E+00 5.62711997779E+00 5.72169230993E+00 5.81785405593E+00 5.91563192800E+00 6.01505308730E+00 6.11614515145E+00 6.21893620222E+00 6.32345479336E+00 6.42972995847E+00 6.53779121912E+00 6.64766859301E+00 6.75939260235E+00 6.87299428231E+00 6.98850518963E+00 7.10595741143E+00 7.22538357406E+00 7.34681685225E+00 7.47029097822E+00 7.59584025116E+00 7.72349954665E+00 7.85330432644E+00 7.98529064824E+00 8.11949517578E+00 8.25595518894E+00 8.39470859417E+00 8.53579393498E+00 8.67925040263E+00 8.82511784707E+00 8.97343678797E+00 9.12424842600E+00 9.27759465425E+00 9.43351806987E+00 9.59206198593E+00 9.75327044342E+00 9.91718822351E+00 1.00838608600E+01 1.02533346518E+01 1.04256566762E+01 1.06008748015E+01 1.07790377004E+01 1.09601948640E+01 1.11443966146E+01 1.13316941207E+01 1.15221394106E+01 1.17157853870E+01 1.19126858416E+01 1.21128954703E+01 1.23164698882E+01 1.25234656450E+01 1.27339402409E+01 1.29479521424E+01 1.31655607986E+01 1.33868266577E+01 1.36118111840E+01 1.38405768746E+01 1.40731872770E+01 1.43097070066E+01 1.45502017650E+01 1.47947383577E+01 1.50433847132E+01 1.52962099015E+01 1.55532841534E+01 1.58146788802E+01 1.60804666930E+01 1.63507214237E+01 1.66255181447E+01 1.69049331901E+01 1.71890441772E+01 1.74779300273E+01 1.77716709885E+01 1.80703486573E+01 1.83740460017E+01 1.86828473840E+01 1.89968385844E+01 1.93161068246E+01 1.96407407923E+01 1.99708306658E+01 2.03064681387E+01 2.06477464459E+01 2.09947603891E+01 2.13476063632E+01 2.17063823834E+01 2.20711881119E+01 2.24421248860E+01 2.28192957461E+01 2.32028054642E+01 2.35927605734E+01 2.39892693970E+01 2.43924420789E+01 2.48023906141E+01 2.52192288798E+01 2.56430726671E+01 2.60740397131E+01 2.65122497337E+01 2.69578244567E+01 2.74108876557E+01 2.78715651844E+01 2.83399850120E+01 2.88162772579E+01 2.93005742287E+01 2.97930104543E+01 3.02937227259E+01 3.08028501333E+01 3.13205341042E+01 3.18469184429E+01 3.23821493707E+01 3.29263755663E+01 3.34797482072E+01 3.40424210115E+01 3.46145502808E+01 3.51962949437E+01 3.57878165995E+01 3.63892795638E+01 3.70008509133E+01 3.76227005330E+01 3.82550011629E+01 3.88979284460E+01 3.95516609775E+01 4.02163803539E+01 4.08922712237E+01 4.15795213388E+01 4.22783216064E+01 4.29888661422E+01 4.37113523241E+01 4.44459808476E+01 4.51929557807E+01 4.59524846214E+01 4.67247783547E+01 4.75100515116E+01 4.83085222286E+01 4.91204123084E+01 4.99459472810E+01 5.07853564671E+01 5.16388730414E+01 5.25067340971E+01 5.33891807126E+01 5.42864580173E+01 5.51988152609E+01 5.61265058818E+01 5.70697875778E+01 5.80289223775E+01 5.90041767136E+01 5.99958214963E+01 6.10041321889E+01 6.20293888840E+01 6.30718763819E+01 6.41318842692E+01 6.52097069992E+01 6.63056439741E+01 6.74199996278E+01 6.85530835109E+01 6.97052103760E+01 7.08767002659E+01 7.20678786020E+01 7.32790762747E+01 7.45106297356E+01 7.57628810909E+01 7.70361781962E+01 7.83308747533E+01 7.96473304085E+01 8.09859108524E+01 8.23469879215E+01 8.37309397015E+01 8.51381506324E+01 8.65690116150E+01 8.80239201201E+01 8.95032802982E+01 9.10075030922E+01 9.25370063515E+01 9.40922149479E+01 9.56735608937E+01 9.72814834620E+01 9.89164293082E+01 1.00578852594E+02 1.02269215116E+02 1.03987986428E+02 1.05735643979E+02 1.07512673240E+02 1.09319567842E+02 1.11156829711E+02 1.13024969211E+02 1.14924505280E+02 1.16855965580E+02 1.18819886639E+02 1.20816814005E+02 1.22847302392E+02 1.24911915838E+02 1.27011227860E+02 1.29145821612E+02 1.31316290053E+02 1.33523236104E+02 1.35767272818E+02 1.38049023556E+02 1.40369122150E+02 1.42728213087E+02 1.45126951687E+02 1.47566004279E+02 1.50046048396E+02 1.52567772953E+02 1.55131878446E+02 1.57739077143E+02 1.60390093283E+02 1.63085663276E+02 1.65826535909E+02 1.68613472553E+02 1.71447247375E+02 1.74328647553E+02 1.77258473494E+02 1.80237539058E+02 1.83266671782E+02 1.86346713112E+02 1.89478518633E+02 1.92662958313E+02 1.95900916739E+02 1.99193293363E+02 2.02541002757E+02 2.05944974860E+02 1.08557376852E-06 1.10381827993E-06 1.12236941463E-06 1.14123232583E-06 1.16041225334E-06 1.17991452506E-06 1.19974455839E-06 1.21990786182E-06 1.24041003639E-06 1.26125677727E-06 1.28245387537E-06 1.30400721891E-06 1.32592279505E-06 1.34820669161E-06 1.37086509870E-06 1.39390431047E-06 1.41733072683E-06 1.44115085530E-06 1.46537131271E-06 1.48999882713E-06 1.51504023969E-06 1.54050250651E-06 1.56639270059E-06 1.59271801383E-06 1.61948575899E-06 1.64670337171E-06 1.67437841262E-06 1.70251856941E-06 1.73113165898E-06 1.76022562958E-06 1.78980856307E-06 1.81988867711E-06 1.85047432748E-06 1.88157401040E-06 1.91319636487E-06 1.94535017507E-06 1.97804437283E-06 2.01128804007E-06 2.04509041138E-06 2.07946087650E-06 2.11440898302E-06 2.14994443896E-06 2.18607711551E-06 2.22281704976E-06 2.26017444749E-06 2.29815968599E-06 2.33678331695E-06 2.37605606941E-06 2.41598885273E-06 2.45659275960E-06 2.49787906914E-06 2.53985925004E-06 2.58254496374E-06 2.62594806763E-06 2.67008061844E-06 2.71495487547E-06 2.76058330409E-06 2.80697857916E-06 2.85415358854E-06 2.90212143673E-06 2.95089544841E-06 3.00048917225E-06 3.05091638460E-06 3.10219109334E-06 3.15432754178E-06 3.20734021259E-06 3.26124383187E-06 3.31605337318E-06 3.37178406174E-06 3.42845137868E-06 3.48607106526E-06 3.54465912733E-06 3.60423183973E-06 3.66480575082E-06 3.72639768707E-06 3.78902475775E-06 3.85270435967E-06 3.91745418202E-06 3.98329221128E-06 4.05023673620E-06 4.11830635293E-06 4.18751997013E-06 4.25789681425E-06 4.32945643486E-06 4.40221871010E-06 4.47620385217E-06 4.55143241299E-06 4.62792528985E-06 4.70570373128E-06 4.78478934288E-06 4.86520409341E-06 4.94697032080E-06 5.03011073842E-06 5.11464844137E-06 5.20060691289E-06 5.28801003087E-06 5.37688207454E-06 5.46724773113E-06 5.55913210280E-06 5.65256071359E-06 5.74755951647E-06 5.84415490061E-06 5.94237369870E-06 6.04224319436E-06 6.14379112976E-06 6.24704571331E-06 6.35203562751E-06 6.45879003689E-06 6.56733859614E-06 6.67771145835E-06 6.78993928334E-06 6.90405324624E-06 7.02008504610E-06 7.13806691473E-06 7.25803162561E-06 7.38001250307E-06 7.50404343145E-06 7.63015886459E-06 7.75839383537E-06 7.88878396543E-06 8.02136547510E-06 8.15617519343E-06 8.29325056841E-06 8.43262967744E-06 8.57435123783E-06 8.71845461758E-06 8.86497984634E-06 9.01396762650E-06 9.16545934453E-06 9.31949708241E-06 9.47612362941E-06 9.63538249391E-06 9.79731791550E-06 9.96197487729E-06 1.01293991184E-05 1.02996371466E-05 1.04727362513E-05 1.06487445168E-05 1.08277108354E-05 1.10096849210E-05 1.11947173232E-05 1.13828594411E-05 1.15741635376E-05 1.17686827540E-05 1.19664711246E-05 1.21675835918E-05 1.23720760217E-05 1.25800052189E-05 1.27914289428E-05 1.30064059238E-05 1.32249958789E-05 1.34472595290E-05 1.36732586154E-05 1.39030559171E-05 1.41367152683E-05 1.43743015756E-05 1.46158808370E-05 1.48615201592E-05 1.51112877771E-05 1.53652530720E-05 1.56234865916E-05 1.58860600690E-05 1.61530464431E-05 1.64245198784E-05 1.67005557859E-05 1.69812308440E-05 1.72666230200E-05 1.75568115911E-05 1.78518771672E-05 1.81519017129E-05 1.84569685702E-05 1.87671624820E-05 1.90825696151E-05 1.94032775846E-05 1.97293754783E-05 2.00609538809E-05 2.03981048997E-05 2.07409221899E-05 2.10895009807E-05 2.14439381019E-05 2.18043320104E-05 2.21707828180E-05 2.25433923190E-05 2.29222640183E-05 2.33075031606E-05 2.36992167592E-05 2.40975136260E-05 2.45025044014E-05 2.49143015857E-05 2.53330195695E-05 2.57587746661E-05 2.61916851434E-05 2.66318712573E-05 2.70794552845E-05 2.75345615567E-05 2.79973164952E-05 2.84678486462E-05 2.89462887159E-05 2.94327696075E-05 2.99274264578E-05 3.04303966744E-05 3.09418199747E-05 3.14618384240E-05 3.19905964751E-05 3.25282410087E-05 3.30749213740E-05 3.36307894301E-05 3.41959995884E-05 3.47707088554E-05 3.53550768761E-05 3.59492659790E-05 3.65534412201E-05 3.71677704300E-05 3.77924242596E-05 3.84275762278E-05 3.90734027698E-05 3.97300832861E-05 4.03978001921E-05 4.10767389690E-05 4.17670882153E-05 4.24690396991E-05 4.31827884115E-05 4.39085326205E-05 4.46464739265E-05 4.53968173179E-05 4.61597712282E-05 4.69355475941E-05 4.77243619138E-05 4.85264333076E-05 4.93419845782E-05 5.01712422729E-05 5.10144367465E-05 5.18718022249E-05 5.27435768708E-05 5.36300028495E-05 5.45313263960E-05 5.54477978838E-05 5.63796718942E-05 5.73272072871E-05 5.82906672729E-05 5.92703194856E-05 6.02664360569E-05 6.12792936925E-05 6.23091737481E-05 6.33563623082E-05 6.44211502653E-05 6.55038334005E-05 6.66047124662E-05 6.77240932692E-05 6.88622867558E-05 7.00196090981E-05 7.11963817822E-05 7.23929316967E-05 7.36095912244E-05 7.48466983341E-05 7.61045966747E-05 7.73836356703E-05 7.86841706178E-05 8.00065627854E-05 8.13511795127E-05 8.27183943129E-05 8.41085869767E-05 8.55221436778E-05 8.69594570797E-05 8.84209264456E-05 8.99069577485E-05 9.14179637845E-05 9.29543642871E-05 9.45165860441E-05 9.61050630162E-05 9.77202364570E-05 9.93625550363E-05 1.01032474964E-04 1.02730460118E-04 1.04456982172E-04 1.06212520725E-04 1.07997563440E-04 1.09812606172E-04 1.11658153112E-04 1.13534716923E-04 1.15442818886E-04 1.17382989041E-04 1.19355766337E-04 1.21361698779E-04 1.23401343585E-04 1.25475267336E-04 1.27584046134E-04 1.29728265765E-04 1.31908521860E-04 1.34125420059E-04 1.36379576182E-04 1.38671616397E-04 1.41002177397E-04 1.43371906576E-04 1.45781462206E-04 1.48231513624E-04 1.50722741416E-04 1.53255837605E-04 1.55831505845E-04 1.58450461617E-04 1.61113432425E-04 1.63821158000E-04 1.66574390505E-04 1.69373894746E-04 1.72220448380E-04 1.75114842134E-04 1.78057880027E-04 1.81050379587E-04 1.84093172082E-04 1.87187102754E-04 1.90333031047E-04 1.93531830850E-04 1.96784390740E-04 2.00091614226E-04 2.03454420002E-04 2.06873742203E-04 2.10350530663E-04 2.13885751178E-04 2.17480385777E-04 2.21135432993E-04 2.24851908140E-04 2.28630843596E-04 2.32473289090E-04 2.36380311993E-04 2.40352997613E-04 2.44392449500E-04 2.48499789750E-04 2.52676159318E-04 2.56922718332E-04 2.61240646420E-04 2.65631143034E-04 2.70095427785E-04 2.74634740780E-04 2.79250342969E-04 2.83943516493E-04 2.88715565042E-04 2.93567814216E-04 2.98501611893E-04 3.03518328603E-04 3.08619357912E-04 3.13806116804E-04 3.19080046081E-04 3.24442610755E-04 3.29895300463E-04 3.35439629875E-04 3.41077139119E-04 3.46809394207E-04 3.52637987467E-04 3.58564537991E-04 3.64590692081E-04 3.70718123708E-04 3.76948534975E-04 3.83283656592E-04 3.89725248357E-04 3.96275099641E-04 4.02935029889E-04 4.09706889125E-04 4.16592558466E-04 4.23593950640E-04 4.30713010524E-04 4.37951715680E-04 4.45312076907E-04 4.52796138797E-04 4.60405980303E-04 4.68143715320E-04 4.76011493268E-04 4.84011499691E-04 4.92145956866E-04 5.00417124415E-04 5.08827299939E-04 5.17378819651E-04 5.26074059029E-04 5.34915433473E-04 5.43905398977E-04 5.53046452811E-04 5.62341134215E-04 5.71792025107E-04 5.81401750793E-04 5.91172980704E-04 6.01108429133E-04 6.11210855991E-04 6.21483067573E-04 6.31927917336E-04 6.42548306695E-04 6.53347185826E-04 6.64327554488E-04 6.75492462854E-04 6.86845012358E-04 6.98388356560E-04 7.10125702018E-04 7.22060309182E-04 7.34195493297E-04 7.46534625325E-04 7.59081132883E-04 7.71838501192E-04 7.84810274048E-04 7.98000054804E-04 8.11411507374E-04 8.25048357246E-04 8.38914392522E-04 8.53013464969E-04 8.67349491085E-04 8.81926453193E-04 8.96748400541E-04 9.11819450434E-04 9.27143789371E-04 9.42725674210E-04 9.58569433355E-04 9.74679467950E-04 9.91060253109E-04 1.00771633916E-03 1.02465235289E-03 1.04187299886E-03 1.05938306070E-03 1.07718740242E-03 1.09529096980E-03 1.11369879170E-03 1.13241598155E-03 1.15144773867E-03 1.17079934979E-03 1.19047619048E-03 1.21048372665E-03 1.23082751609E-03 1.25151320997E-03 1.27254655446E-03 1.29393339229E-03 1.31567966438E-03 1.33779141150E-03 1.36027477595E-03 1.38313600325E-03 1.40638144389E-03 1.43001755508E-03 1.45405090257E-03 1.47848816244E-03 1.50333612297E-03 1.52860168653E-03 1.55429187151E-03 1.58041381422E-03 1.60697477092E-03 1.63398211985E-03 1.66144336320E-03 1.68936612928E-03 1.71775817459E-03 1.74662738600E-03 1.77598178291E-03 1.80582951951E-03 1.83617888704E-03 1.86703831606E-03 1.89841637884E-03 1.93032179172E-03 1.96276341750E-03 1.99575026796E-03 2.02929150634E-03 2.06339644984E-03 2.09807457230E-03 2.13333550673E-03 2.16918904808E-03 2.20564515590E-03 2.24271395710E-03 2.28040574883E-03 2.31873100126E-03 2.35770036054E-03 2.39732465175E-03 2.43761488189E-03 2.47858224295E-03 2.52023811502E-03 2.56259406943E-03 2.60566187200E-03 2.64945348630E-03 2.69398107693E-03 2.73925701297E-03 2.78529387134E-03 2.83210444037E-03 2.87970172328E-03 2.92809894185E-03 2.97730954007E-03 3.02734718787E-03 3.07822578490E-03 3.12995946444E-03 3.18256259730E-03 3.23604979578E-03 3.29043591780E-03 3.34573607095E-03 3.40196561674E-03 3.45914017486E-03 3.51727562749E-03 3.57638812375E-03 3.63649408414E-03 3.69761020517E-03 3.75975346392E-03 3.82294112280E-03 3.88719073436E-03 3.95252014611E-03 4.01894750555E-03 4.08649126513E-03 4.15517018745E-03 4.22500335044E-03 4.29601015263E-03 4.36821031859E-03 4.44162390441E-03 4.51627130319E-03 4.59217325083E-03 4.66935083167E-03 4.74782548444E-03 4.82761900815E-03 4.90875356818E-03 4.99125170243E-03 5.07513632758E-03 5.16043074546E-03 5.24715864950E-03 5.33534413135E-03 5.42501168755E-03 5.51618622632E-03 5.60889307451E-03 5.70315798462E-03 5.79900714196E-03 5.89646717190E-03 5.99556514730E-03 6.09632859602E-03 6.19878550855E-03 6.30296434580E-03 6.40889404701E-03 6.51660403777E-03 6.62612423823E-03 6.73748507135E-03 6.85071747144E-03 6.96585289264E-03 7.08292331778E-03 7.20196126716E-03 7.32299980764E-03 7.44607256183E-03 7.57121371738E-03 7.69845803654E-03 7.82784086577E-03 7.95939814557E-03 8.09316642048E-03 8.22918284921E-03 8.36748521499E-03 8.50811193601E-03 8.65110207617E-03 8.79649535587E-03 8.94433216306E-03 9.09465356448E-03 9.24750131703E-03 9.40291787941E-03 9.56094642389E-03 9.72163084829E-03 9.88501578822E-03 1.00511466294E-02 1.02200695204E-02 1.03918313854E-02 1.05664799370E-02 1.07440636898E-02 1.09246319739E-02 1.11082349482E-02 1.12949236147E-02 1.14847498327E-02 1.16777663328E-02 1.18740267319E-02 1.20735855482E-02 1.22764982159E-02 1.24828211009E-02 1.26926115164E-02 1.29059277390E-02 1.31228290246E-02 1.33433756248E-02 1.35676288040E-02 1.37956508562E-02 1.40275051224E-02 1.42632560080E-02 1.45029690008E-02 1.47467106894E-02 1.49945487814E-02 1.52465521222E-02 1.55027907144E-02 1.57633357371E-02 1.60282595655E-02 1.62976357913E-02 1.65715392429E-02 1.68500460064E-02 1.71332334466E-02 1.74211802285E-02 1.77139663391E-02 1.80116731099E-02 1.83143832390E-02 1.86221808145E-02 1.89351513378E-02 1.92533817471E-02 1.95769604418E-02 1.99059773069E-02 2.02405237382E-02 2.05806926673E-02 2.09265785879E-02 2.12782775815E-02 2.16358873446E-02 2.19995072155E-02 2.23692382021E-02 2.27451830098E-02 2.31274460702E-02 2.35161335698E-02 2.39113534800E-02 2.43132155866E-02 2.47218315205E-02 2.51373147887E-02 2.55597808061E-02 2.59893469269E-02 2.64261324779E-02 2.68702587912E-02 2.73218492380E-02 2.77810292630E-02 2.82479264193E-02 2.87226704034E-02 2.92053930918E-02 2.96962285772E-02 3.01953132059E-02 3.07027856157E-02 3.12187867745E-02 3.17434600193E-02 3.22769510960E-02 3.28194082000E-02 3.33709820173E-02 3.39318257664E-02 3.45020952408E-02 3.50819488525E-02 3.56715476755E-02 3.62710554911E-02 3.68806388331E-02 3.75004670342E-02 3.81307122728E-02 3.87715496212E-02 3.94231570937E-02 4.00857156967E-02 4.07594094784E-02 4.14444255805E-02 4.21409542895E-02 4.28491890900E-02 4.35693267187E-02 4.43015672182E-02 4.50461139935E-02 4.58031738679E-02 4.65729571407E-02 4.73556776454E-02 4.81515528096E-02 4.89608037147E-02 4.97836551579E-02 5.06203357144E-02 5.14710778006E-02 5.23361177395E-02 5.32156958254E-02 5.41100563911E-02 5.50194478761E-02 5.59441228947E-02 5.68843383073E-02 5.78403552907E-02 5.88124394113E-02 5.98008606989E-02 6.08058937212E-02 6.18278176605E-02 6.28669163912E-02 6.39234785584E-02 6.49977976585E-02 6.60901721203E-02 6.72009053883E-02 6.83303060065E-02 6.94786877046E-02 7.06463694850E-02 7.18336757111E-02 7.30409361980E-02 7.42684863035E-02 7.55166670216E-02 7.67858250772E-02 7.80763130224E-02 7.93884893344E-02 8.07227185151E-02 8.20793711921E-02 8.34588242222E-02 8.48614607958E-02 8.62876705430E-02 8.77378496424E-02 8.92124009308E-02 9.07117340154E-02 9.22362653872E-02 9.37864185369E-02 9.53626240726E-02 9.69653198392E-02 9.85949510405E-02 1.00251970362E-01 1.01936838098E-01 1.03650022277E-01 1.05391998796E-01 1.07163251548E-01 1.08964272559E-01 1.10795562124E-01 1.12657628946E-01 1.14550990279E-01 1.16476172068E-01 1.18433709098E-01 1.20424145142E-01 1.22448033111E-01 1.24505935211E-01 1.26598423093E-01 1.28726078018E-01 1.30889491014E-01 1.33089263045E-01 1.35326005170E-01 1.37600338723E-01 1.39912895477E-01 1.42264317823E-01 1.44655258951E-01 1.47086383025E-01 1.49558365373E-01 1.52071892674E-01 1.54627663145E-01 1.57226386738E-01 1.59868785339E-01 1.62555592964E-01 1.65287555966E-01 1.68065433240E-01 1.70889996437E-01 1.73762030177E-01 1.76682332265E-01 1.79651713914E-01 1.82670999973E-01 1.85741029150E-01 1.88862654253E-01 1.92036742418E-01 1.95264175357E-01 1.98545849601E-01 2.01882676746E-01 2.05275583711E-01 2.08725512991E-01 2.12233422922E-01 2.15800287947E-01 2.19427098883E-01 2.23114863203E-01 2.26864605308E-01 2.30677366818E-01 2.34554206857E-01 2.38496202351E-01 2.42504448324E-01 2.46580058202E-01 2.50724164127E-01 2.54937917265E-01 2.59222488131E-01 2.63579066910E-01 2.68008863791E-01 2.72513109302E-01 2.77093054652E-01 2.81749972076E-01 2.86485155193E-01 2.91299919362E-01 2.96195602048E-01 3.01173563195E-01 3.06235185602E-01 3.11381875307E-01 3.16615061980E-01 3.21936199317E-01 3.27346765446E-01 3.32848263337E-01 3.38442221219E-01 3.44130193005E-01 3.49913758725E-01 3.55794524961E-01 3.61774125297E-01 3.67854220772E-01 3.74036500340E-01 3.80322681341E-01 3.86714509977E-01 3.93213761797E-01 3.99822242190E-01 4.06541786888E-01 4.13374262475E-01 4.20321566903E-01 4.27385630025E-01 4.34568414125E-01 4.41871914469E-01 4.49298159852E-01 4.56849213168E-01 4.64527171981E-01 4.72334169107E-01 4.80272373206E-01 4.88343989385E-01 4.96551259813E-01 5.04896464339E-01 5.13381921130E-01 5.22009987310E-01 5.30783059622E-01 5.39703575085E-01 5.48774011679E-01 5.57996889027E-01 5.67374769098E-01 5.76910256920E-01 5.86606001301E-01 5.96464695566E-01 6.06489078303E-01 6.16681934129E-01 6.27046094457E-01 6.37584438288E-01 6.48299893007E-01 6.59195435198E-01 6.70274091471E-01 6.81538939302E-01 6.92993107887E-01 7.04639779014E-01 7.16482187943E-01 7.28523624309E-01 7.40767433034E-01 7.53217015253E-01 7.65875829264E-01 7.78747391485E-01 7.91835277434E-01 8.05143122718E-01 8.18674624046E-01 8.32433540257E-01 8.46423693359E-01 8.60648969597E-01 8.75113320526E-01 8.89820764116E-01 9.04775385863E-01 9.19981339923E-01 9.35442850271E-01 9.51164211870E-01 9.67149791866E-01 9.83404030801E-01 9.99931443846E-01 1.01673662205E+00 1.03382423364E+00 1.05119902527E+00 1.06886582339E+00 1.08682953556E+00 1.10509515181E+00 1.12366774604E+00 1.14255247742E+00 1.16175459184E+00 1.18127942334E+00 1.20113239561E+00 1.22131902348E+00 1.24184491450E+00 1.26271577042E+00 1.28393738884E+00 1.30551566480E+00 1.32745659238E+00 1.34976626645E+00 1.37245088427E+00 1.39551674727E+00 1.41897026278E+00 1.44281794582E+00 1.46706642091E+00 1.49172242388E+00 1.51679280378E+00 1.54228452477E+00 1.56820466804E+00 1.59456043380E+00 1.62135914327E+00 1.64860824071E+00 1.67631529548E+00 1.70448800417E+00 1.73313419271E+00 1.76226181855E+00 1.79187897290E+00 1.82199388293E+00 1.85261491409E+00 1.88375057242E+00 1.91540950690E+00 1.94760051190E+00 1.98033252956E+00 2.01361465233E+00 2.04745612545E+00 2.08186634954E+00 2.11685488323E+00 2.15243144578E+00 2.18860591979E+00 2.22538835397E+00 2.26278896588E+00 2.30081814484E+00 2.33948645474E+00 2.37880463703E+00 2.41878361368E+00 2.45943449023E+00 2.50076855883E+00 2.54279730145E+00 2.58553239301E+00 2.62898570463E+00 2.67316930696E+00 2.71809547351E+00 2.76377668406E+00 2.81022562813E+00 2.85745520849E+00 2.90547854479E+00 2.95430897715E+00 3.00396006988E+00 3.05444561528E+00 3.10577963744E+00 3.15797639613E+00 3.21105039080E+00 3.26501636455E+00 3.31988930829E+00 3.37568446485E+00 3.43241733325E+00 0.00000000000E+00 6.82005082729E-01 6.82005082725E-01 6.82005082718E-01 6.82005082708E-01 6.82005082696E-01 6.82005082680E-01 6.82005082661E-01 6.82005082638E-01 6.82005082611E-01 6.82005082581E-01 6.82005082546E-01 6.82005082508E-01 6.82005082465E-01 6.82005082417E-01 6.82005082364E-01 6.82005082306E-01 6.82005082243E-01 6.82005082175E-01 6.82005082100E-01 6.82005082020E-01 6.82005081933E-01 6.82005081840E-01 6.82005081740E-01 6.82005081633E-01 6.82005081518E-01 6.82005081395E-01 6.82005081265E-01 6.82005081126E-01 6.82005080978E-01 6.82005080821E-01 6.82005080654E-01 6.82005080478E-01 6.82005080291E-01 6.82005080093E-01 6.82005079884E-01 6.82005079664E-01 6.82005079431E-01 6.82005079186E-01 6.82005078927E-01 6.82005078655E-01 6.82005078369E-01 6.82005078068E-01 6.82005077751E-01 6.82005077419E-01 6.82005077070E-01 6.82005076703E-01 6.82005076319E-01 6.82005075916E-01 6.82005075494E-01 6.82005075052E-01 6.82005074588E-01 6.82005074103E-01 6.82005073596E-01 6.82005073065E-01 6.82005072510E-01 6.82005071929E-01 6.82005071323E-01 6.82005070689E-01 6.82005070027E-01 6.82005069336E-01 6.82005068614E-01 6.82005067861E-01 6.82005067075E-01 6.82005066255E-01 6.82005065399E-01 6.82005064508E-01 6.82005063578E-01 6.82005062609E-01 6.82005061599E-01 6.82005060547E-01 6.82005059451E-01 6.82005058309E-01 6.82005057121E-01 6.82005055883E-01 6.82005054595E-01 6.82005053253E-01 6.82005051858E-01 6.82005050406E-01 6.82005048895E-01 6.82005047323E-01 6.82005045689E-01 6.82005043989E-01 6.82005042221E-01 6.82005040384E-01 6.82005038473E-01 6.82005036488E-01 6.82005034424E-01 6.82005032280E-01 6.82005030051E-01 6.82005027736E-01 6.82005025331E-01 6.82005022832E-01 6.82005020238E-01 6.82005017543E-01 6.82005014744E-01 6.82005011838E-01 6.82005008821E-01 6.82005005689E-01 6.82005002437E-01 6.82004999062E-01 6.82004995559E-01 6.82004991923E-01 6.82004988150E-01 6.82004984235E-01 6.82004980173E-01 6.82004975959E-01 6.82004971586E-01 6.82004967050E-01 6.82004962345E-01 6.82004957464E-01 6.82004952402E-01 6.82004947153E-01 6.82004941708E-01 6.82004936063E-01 6.82004930208E-01 6.82004924138E-01 6.82004917845E-01 6.82004911320E-01 6.82004904556E-01 6.82004897543E-01 6.82004890275E-01 6.82004882740E-01 6.82004874931E-01 6.82004866837E-01 6.82004858448E-01 6.82004849754E-01 6.82004840745E-01 6.82004831410E-01 6.82004821736E-01 6.82004811712E-01 6.82004801326E-01 6.82004790565E-01 6.82004779417E-01 6.82004767867E-01 6.82004755902E-01 6.82004743506E-01 6.82004730666E-01 6.82004717366E-01 6.82004703589E-01 6.82004689319E-01 6.82004674539E-01 6.82004659232E-01 6.82004643378E-01 6.82004626959E-01 6.82004609955E-01 6.82004592346E-01 6.82004574111E-01 6.82004555229E-01 6.82004535676E-01 6.82004515429E-01 6.82004494465E-01 6.82004472759E-01 6.82004450285E-01 6.82004427016E-01 6.82004402925E-01 6.82004377984E-01 6.82004352163E-01 6.82004325431E-01 6.82004297758E-01 6.82004269110E-01 6.82004239455E-01 6.82004208757E-01 6.82004176980E-01 6.82004144087E-01 6.82004110040E-01 6.82004074799E-01 6.82004038323E-01 6.82004000569E-01 6.82003961493E-01 6.82003921050E-01 6.82003879192E-01 6.82003835871E-01 6.82003791037E-01 6.82003744637E-01 6.82003696619E-01 6.82003646925E-01 6.82003595498E-01 6.82003542280E-01 6.82003487208E-01 6.82003430218E-01 6.82003371246E-01 6.82003310222E-01 6.82003247077E-01 6.82003181737E-01 6.82003114127E-01 6.82003044170E-01 6.82002971785E-01 6.82002896888E-01 6.82002819394E-01 6.82002739214E-01 6.82002656255E-01 6.82002570422E-01 6.82002481618E-01 6.82002389739E-01 6.82002294681E-01 6.82002196335E-01 6.82002094588E-01 6.82001989324E-01 6.82001880423E-01 6.82001767760E-01 6.82001651206E-01 6.82001530629E-01 6.82001405890E-01 6.82001276848E-01 6.82001143356E-01 6.82001005260E-01 6.82000862405E-01 6.82000714626E-01 6.82000561757E-01 6.82000403623E-01 6.82000240043E-01 6.82000070833E-01 6.81999895800E-01 6.81999714745E-01 6.81999527463E-01 6.81999333740E-01 6.81999133357E-01 6.81998926087E-01 6.81998711695E-01 6.81998489937E-01 6.81998260563E-01 6.81998023312E-01 6.81997777915E-01 6.81997524096E-01 6.81997261566E-01 6.81996990029E-01 6.81996709178E-01 6.81996418694E-01 6.81996118251E-01 6.81995807507E-01 6.81995486112E-01 6.81995153703E-01 6.81994809905E-01 6.81994454329E-01 6.81994086575E-01 6.81993706227E-01 6.81993312856E-01 6.81992906019E-01 6.81992485258E-01 6.81992050097E-01 6.81991600047E-01 6.81991134600E-01 6.81990653232E-01 6.81990155402E-01 6.81989640548E-01 6.81989108092E-01 6.81988557434E-01 6.81987987954E-01 6.81987399012E-01 6.81986789946E-01 6.81986160071E-01 6.81985508679E-01 6.81984835037E-01 6.81984138389E-01 6.81983417952E-01 6.81982672917E-01 6.81981902447E-01 6.81981105676E-01 6.81980281711E-01 6.81979429627E-01 6.81978548467E-01 6.81977637242E-01 6.81976694931E-01 6.81975720475E-01 6.81974712783E-01 6.81973670724E-01 6.81972593131E-01 6.81971478794E-01 6.81970326465E-01 6.81969134853E-01 6.81967902623E-01 6.81966628393E-01 6.81965310737E-01 6.81963948178E-01 6.81962539192E-01 6.81961082200E-01 6.81959575571E-01 6.81958017618E-01 6.81956406598E-01 6.81954740708E-01 6.81953018084E-01 6.81951236798E-01 6.81949394858E-01 6.81947490204E-01 6.81945520705E-01 6.81943484158E-01 6.81941378287E-01 6.81939200737E-01 6.81936949074E-01 6.81934620781E-01 6.81932213256E-01 6.81929723808E-01 6.81927149655E-01 6.81924487922E-01 6.81921735635E-01 6.81918889720E-01 6.81915946997E-01 6.81912904180E-01 6.81909757872E-01 6.81906504559E-01 6.81903140608E-01 6.81899662266E-01 6.81896065647E-01 6.81892346739E-01 6.81888501391E-01 6.81884525311E-01 6.81880414063E-01 6.81876163060E-01 6.81871767559E-01 6.81867222656E-01 6.81862523283E-01 6.81857664198E-01 6.81852639981E-01 6.81847445030E-01 6.81842073553E-01 6.81836519561E-01 6.81830776861E-01 6.81824839053E-01 6.81818699517E-01 6.81812351411E-01 6.81805787660E-01 6.81799000949E-01 6.81791983717E-01 6.81784728145E-01 6.81777226150E-01 6.81769469374E-01 6.81761449178E-01 6.81753156629E-01 6.81744582491E-01 6.81735717217E-01 6.81726550934E-01 6.81717073438E-01 6.81707274177E-01 6.81697142241E-01 6.81686666354E-01 6.81675834855E-01 6.81664635690E-01 6.81653056397E-01 6.81641084091E-01 6.81628705451E-01 6.81615906706E-01 6.81602673619E-01 6.81588991470E-01 6.81574845044E-01 6.81560218606E-01 6.81545095894E-01 6.81529460092E-01 6.81513293818E-01 6.81496579101E-01 6.81479297360E-01 6.81461429390E-01 6.81442955334E-01 6.81423854663E-01 6.81404106157E-01 6.81383687875E-01 6.81362577136E-01 6.81340750495E-01 6.81318183710E-01 6.81294851725E-01 6.81270728633E-01 6.81245787655E-01 6.81220001107E-01 6.81193340369E-01 6.81165775856E-01 6.81137276984E-01 6.81107812137E-01 6.81077348629E-01 6.81045852677E-01 6.81013289353E-01 6.80979622553E-01 6.80944814955E-01 6.80908827980E-01 6.80871621746E-01 6.80833155029E-01 6.80793385215E-01 6.80752268253E-01 6.80709758610E-01 6.80665809219E-01 6.80620371429E-01 6.80573394951E-01 6.80524827802E-01 6.80474616252E-01 6.80422704765E-01 6.80369035935E-01 6.80313550428E-01 6.80256186916E-01 6.80196882009E-01 6.80135570190E-01 6.80072183742E-01 6.80006652676E-01 6.79938904652E-01 6.79868864907E-01 6.79796456170E-01 6.79721598582E-01 6.79644209605E-01 6.79564203942E-01 6.79481493439E-01 6.79395986991E-01 6.79307590448E-01 6.79216206513E-01 6.79121734639E-01 6.79024070920E-01 6.78923107983E-01 6.78818734873E-01 6.78710836937E-01 6.78599295701E-01 6.78483988745E-01 6.78364789578E-01 6.78241567499E-01 6.78114187465E-01 6.77982509948E-01 6.77846390788E-01 6.77705681047E-01 6.77560226847E-01 6.77409869219E-01 6.77254443932E-01 6.77093781326E-01 6.76927706138E-01 6.76756037321E-01 6.76578587860E-01 6.76395164580E-01 6.76205567951E-01 6.76009591883E-01 6.75807023520E-01 6.75597643026E-01 6.75381223363E-01 6.75157530065E-01 6.74926321003E-01 6.74687346146E-01 6.74440347316E-01 6.74185057929E-01 6.73921202738E-01 6.73648497564E-01 6.73366649018E-01 6.73075354223E-01 6.72774300515E-01 6.72463165154E-01 6.72141615010E-01 6.71809306251E-01 6.71465884021E-01 6.71110982110E-01 6.70744222612E-01 6.70365215578E-01 6.69973558663E-01 6.69568836756E-01 6.69150621612E-01 6.68718471467E-01 6.68271930648E-01 6.67810529171E-01 6.67333782337E-01 6.66841190314E-01 6.66332237709E-01 6.65806393135E-01 6.65263108769E-01 6.64701819902E-01 6.64121944476E-01 6.63522882618E-01 6.62904016167E-01 6.62264708188E-01 6.61604302484E-01 6.60922123095E-01 6.60217473799E-01 6.59489637598E-01 6.58737876202E-01 6.57961429513E-01 6.57159515093E-01 6.56331327636E-01 6.55476038440E-01 6.54592794866E-01 6.53680719803E-01 6.52738911136E-01 6.51766441203E-01 6.50762356263E-01 6.49725675968E-01 6.48655392832E-01 6.47550471713E-01 6.46409849298E-01 6.45232433604E-01 6.44017103482E-01 6.42762708139E-01 6.41468066680E-01 6.40131967659E-01 6.38753168660E-01 6.37330395894E-01 6.35862343832E-01 6.34347674856E-01 6.32785018955E-01 6.31172973451E-01 6.29510102769E-01 6.27794938252E-01 6.26025978026E-01 6.24201686917E-01 6.22320496434E-01 6.20380804807E-01 6.18380977111E-01 6.16319345449E-01 6.14194209233E-01 6.12003835546E-01 6.09746459608E-01 6.07420285341E-01 6.05023486054E-01 6.02554205239E-01 6.00010557509E-01 5.97390629665E-01 5.94692481922E-01 5.91914149285E-01 5.89053643101E-01 5.86108952792E-01 5.83078047778E-01 5.79958879606E-01 5.76749384299E-01 5.73447484932E-01 5.70051094452E-01 5.66558118763E-01 5.62966460071E-01 5.59274020530E-01 5.55478706180E-01 5.51578431209E-01 5.47571122547E-01 5.43454724812E-01 5.39227205622E-01 5.34886561291E-01 5.30430822925E-01 5.25858062939E-01 5.21166402007E-01 5.16354016460E-01 5.11419146159E-01 5.06360102848E-01 5.01175279011E-01 4.95863157242E-01 4.90422320149E-01 4.84851460801E-01 4.79149393728E-01 4.73315066501E-01 4.67347571875E-01 4.61246160529E-01 4.55010254394E-01 4.48639460572E-01 4.42133585856E-01 4.35492651835E-01 4.28716910589E-01 4.21806860953E-01 4.14763265344E-01 4.07587167115E-01 4.00279908425E-01 3.92843148578E-01 3.85278882789E-01 3.77589461333E-01 3.69777609003E-01 3.61846444811E-01 3.53799501845E-01 3.45640747172E-01 3.37374601679E-01 3.29005959708E-01 3.20540208332E-01 3.11983246084E-01 3.03341500938E-01 2.94621947303E-01 2.85832121762E-01 2.76980137243E-01 2.68074695289E-01 2.59125096033E-01 2.50141245439E-01 2.41133659322E-01 2.32113463621E-01 2.23092390301E-01 2.14082768254E-01 2.05097508462E-01 1.96150082663E-01 1.87254494684E-01 1.78425243575E-01 1.69677277631E-01 1.61025938391E-01 1.52486893698E-01 1.44076058961E-01 1.35809505849E-01 1.27703357791E-01 1.19773671904E-01 1.12036307252E-01 1.04506779807E-01 9.72001050083E-02 9.01306295340E-02 8.33118547686E-02 7.67562554811E-02 7.04750984388E-02 6.44782670273E-02 5.87740993751E-02 5.33692488858E-02 4.82685772771E-02 4.34750909301E-02 3.89899311196E-02 3.48124268802E-02 3.09402149081E-02 2.73694226467E-02 2.40948966216E-02 2.11104354848E-02 1.84089523441E-02 1.59824386416E-02 1.38215250333E-02 1.19143238168E-02 1.02439342561E-02 8.78746159841E-03 7.52041517548E-03 6.42074200163E-03 5.46861075685E-03 4.64622852158E-03 3.93766891957E-03 3.32871116005E-03 2.80668941619E-03 2.36035205545E-03 1.97973026094E-03 1.65601570349E-03 1.38144689584E-03 1.14920394718E-03 9.53311368263E-04 7.88548635653E-04 6.50368146938E-04 5.34820241991E-04 4.38484899463E-04 3.58409754197E-04 2.92054033289E-04 2.37238041937E-04 1.92097800461E-04 1.55044465282E-04 1.24728152410E-04 1.00005811537E-04 7.99127965805E-05 6.36378061949E-05 5.05008740267E-05 3.99341142991E-05 3.14649400677E-05 2.47014954025E-05 1.93200575886E-05 1.50541873577E-05 1.16854212358E-05 9.03531988566E-06 6.95870229105E-06 5.33791317887E-06 4.07798602089E-06 3.10257920358E-06 2.35057631464E-06 1.77325445202E-06 1.33193596024E-06 9.96049758780E-07 7.41538002884E-07 5.49552542757E-07 4.05393386857E-07 2.97648282880E-07 2.17498614321E-07 1.58162149004E-07 1.14447834022E-07 8.24018587731E-08 5.90276837922E-08 4.20656985584E-08 2.98207012351E-08 2.10275245918E-08 1.47469284615E-08 1.02853739666E-08 7.13353883336E-09 4.91945618897E-09 3.37299986155E-09 2.29912220493E-09 1.55780444017E-09 1.04912413156E-09 7.02200327794E-10 4.67059016024E-10 3.08684366475E-10 2.02695625210E-10 1.32225385984E-10 8.56799113618E-11 5.51428141477E-11 3.52448532685E-11 2.23691507982E-11 1.40961155246E-11 8.81847946813E-12 5.47620094143E-12 3.37522326506E-12 2.06446763185E-12 1.25296801686E-12 7.54468335496E-13 4.50663985485E-13 2.67002942105E-13 1.56880883449E-13 9.14014495831E-14 5.27961648590E-14 3.02310982378E-14 1.71570499109E-14 9.64944197692E-15 5.37731283091E-15 2.96868026136E-15 1.62340524652E-15 8.79194829097E-16 4.71483081333E-16 2.50320802946E-16 1.31553842261E-16 6.84243527075E-17 3.52161691119E-17 1.79316533508E-17 9.03164338344E-18 4.49885250128E-18 2.21587076273E-18 1.07897811781E-18 5.19306391498E-19 2.46997996303E-19 1.16073431672E-19 5.38838379605E-20 2.47049525034E-20 1.11846392885E-20 4.99865649236E-21 2.20542056023E-21 9.60308972034E-22 4.12737205672E-22 1.75197345008E-22 7.34082501221E-23 3.05347152633E-23 1.26912945299E-23 5.04810866511E-24 1.97864196386E-24 7.64038343019E-25 2.90578815988E-25 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 -1.00451207669E+01 -1.00451207669E+01 -1.00451207670E+01 -1.00451207667E+01 -1.00451207667E+01 -1.00451207667E+01 -1.00451207666E+01 -1.00451207665E+01 -1.00451207664E+01 -1.00451207662E+01 -1.00451207661E+01 -1.00451207659E+01 -1.00451207657E+01 -1.00451207655E+01 -1.00451207652E+01 -1.00451207649E+01 -1.00451207646E+01 -1.00451207643E+01 -1.00451207640E+01 -1.00451207636E+01 -1.00451207631E+01 -1.00451207627E+01 -1.00451207622E+01 -1.00451207617E+01 -1.00451207611E+01 -1.00451207605E+01 -1.00451207599E+01 -1.00451207592E+01 -1.00451207585E+01 -1.00451207577E+01 -1.00451207569E+01 -1.00451207561E+01 -1.00451207551E+01 -1.00451207542E+01 -1.00451207531E+01 -1.00451207521E+01 -1.00451207509E+01 -1.00451207497E+01 -1.00451207484E+01 -1.00451207471E+01 -1.00451207457E+01 -1.00451207442E+01 -1.00451207426E+01 -1.00451207410E+01 -1.00451207392E+01 -1.00451207374E+01 -1.00451207355E+01 -1.00451207335E+01 -1.00451207314E+01 -1.00451207292E+01 -1.00451207269E+01 -1.00451207245E+01 -1.00451207220E+01 -1.00451207194E+01 -1.00451207166E+01 -1.00451207137E+01 -1.00451207107E+01 -1.00451207076E+01 -1.00451207043E+01 -1.00451207008E+01 -1.00451206972E+01 -1.00451206935E+01 -1.00451206896E+01 -1.00451206855E+01 -1.00451206812E+01 -1.00451206768E+01 -1.00451206721E+01 -1.00451206673E+01 -1.00451206623E+01 -1.00451206570E+01 -1.00451206515E+01 -1.00451206459E+01 -1.00451206399E+01 -1.00451206337E+01 -1.00451206273E+01 -1.00451206206E+01 -1.00451206136E+01 -1.00451206064E+01 -1.00451205988E+01 -1.00451205910E+01 -1.00451205828E+01 -1.00451205743E+01 -1.00451205655E+01 -1.00451205563E+01 -1.00451205468E+01 -1.00451205368E+01 -1.00451205265E+01 -1.00451205158E+01 -1.00451205046E+01 -1.00451204931E+01 -1.00451204810E+01 -1.00451204685E+01 -1.00451204555E+01 -1.00451204420E+01 -1.00451204280E+01 -1.00451204135E+01 -1.00451203984E+01 -1.00451203827E+01 -1.00451203664E+01 -1.00451203495E+01 -1.00451203320E+01 -1.00451203138E+01 -1.00451202949E+01 -1.00451202753E+01 -1.00451202549E+01 -1.00451202338E+01 -1.00451202119E+01 -1.00451201892E+01 -1.00451201656E+01 -1.00451201412E+01 -1.00451201158E+01 -1.00451200895E+01 -1.00451200622E+01 -1.00451200339E+01 -1.00451200046E+01 -1.00451199741E+01 -1.00451199426E+01 -1.00451199099E+01 -1.00451198760E+01 -1.00451198408E+01 -1.00451198044E+01 -1.00451197666E+01 -1.00451197274E+01 -1.00451196868E+01 -1.00451196448E+01 -1.00451196012E+01 -1.00451195560E+01 -1.00451195092E+01 -1.00451194606E+01 -1.00451194104E+01 -1.00451193583E+01 -1.00451193043E+01 -1.00451192484E+01 -1.00451191904E+01 -1.00451191304E+01 -1.00451190682E+01 -1.00451190038E+01 -1.00451189371E+01 -1.00451188679E+01 -1.00451187963E+01 -1.00451187222E+01 -1.00451186453E+01 -1.00451185658E+01 -1.00451184834E+01 -1.00451183981E+01 -1.00451183097E+01 -1.00451182182E+01 -1.00451181234E+01 -1.00451180252E+01 -1.00451179236E+01 -1.00451178184E+01 -1.00451177094E+01 -1.00451175966E+01 -1.00451174798E+01 -1.00451173589E+01 -1.00451172337E+01 -1.00451171041E+01 -1.00451169699E+01 -1.00451168309E+01 -1.00451166871E+01 -1.00451165382E+01 -1.00451163841E+01 -1.00451162245E+01 -1.00451160594E+01 -1.00451158884E+01 -1.00451157115E+01 -1.00451155283E+01 -1.00451153387E+01 -1.00451151425E+01 -1.00451149394E+01 -1.00451147292E+01 -1.00451145117E+01 -1.00451142865E+01 -1.00451140535E+01 -1.00451138124E+01 -1.00451135628E+01 -1.00451133045E+01 -1.00451130372E+01 -1.00451127606E+01 -1.00451124744E+01 -1.00451121782E+01 -1.00451118717E+01 -1.00451115546E+01 -1.00451112264E+01 -1.00451108868E+01 -1.00451105354E+01 -1.00451101718E+01 -1.00451097956E+01 -1.00451094064E+01 -1.00451090036E+01 -1.00451085869E+01 -1.00451081557E+01 -1.00451077096E+01 -1.00451072481E+01 -1.00451067706E+01 -1.00451062765E+01 -1.00451057654E+01 -1.00451052366E+01 -1.00451046895E+01 -1.00451041235E+01 -1.00451035380E+01 -1.00451029322E+01 -1.00451023056E+01 -1.00451016573E+01 -1.00451009866E+01 -1.00451002928E+01 -1.00450995751E+01 -1.00450988326E+01 -1.00450980646E+01 -1.00450972701E+01 -1.00450964482E+01 -1.00450955981E+01 -1.00450947187E+01 -1.00450938090E+01 -1.00450928680E+01 -1.00450918946E+01 -1.00450908878E+01 -1.00450898464E+01 -1.00450887692E+01 -1.00450876549E+01 -1.00450865024E+01 -1.00450853103E+01 -1.00450840773E+01 -1.00450828019E+01 -1.00450814828E+01 -1.00450801183E+01 -1.00450787071E+01 -1.00450772475E+01 -1.00450757378E+01 -1.00450741764E+01 -1.00450725614E+01 -1.00450708910E+01 -1.00450691635E+01 -1.00450673767E+01 -1.00450655288E+01 -1.00450636175E+01 -1.00450616408E+01 -1.00450595964E+01 -1.00450574820E+01 -1.00450552953E+01 -1.00450530338E+01 -1.00450506948E+01 -1.00450482759E+01 -1.00450457742E+01 -1.00450431870E+01 -1.00450405112E+01 -1.00450377441E+01 -1.00450348823E+01 -1.00450319227E+01 -1.00450288620E+01 -1.00450256967E+01 -1.00450224233E+01 -1.00450190380E+01 -1.00450155372E+01 -1.00450119168E+01 -1.00450081727E+01 -1.00450043009E+01 -1.00450002968E+01 -1.00449961561E+01 -1.00449918741E+01 -1.00449874460E+01 -1.00449828668E+01 -1.00449781314E+01 -1.00449732344E+01 -1.00449681704E+01 -1.00449629337E+01 -1.00449575184E+01 -1.00449519185E+01 -1.00449461277E+01 -1.00449401394E+01 -1.00449339471E+01 -1.00449275437E+01 -1.00449209221E+01 -1.00449140748E+01 -1.00449069943E+01 -1.00448996725E+01 -1.00448921013E+01 -1.00448842722E+01 -1.00448761765E+01 -1.00448678050E+01 -1.00448591486E+01 -1.00448501973E+01 -1.00448409413E+01 -1.00448313701E+01 -1.00448214732E+01 -1.00448112394E+01 -1.00448006573E+01 -1.00447897150E+01 -1.00447784004E+01 -1.00447667008E+01 -1.00447546032E+01 -1.00447420939E+01 -1.00447291592E+01 -1.00447157844E+01 -1.00447019548E+01 -1.00446876547E+01 -1.00446728685E+01 -1.00446575793E+01 -1.00446417704E+01 -1.00446254239E+01 -1.00446085217E+01 -1.00445910449E+01 -1.00445729741E+01 -1.00445542890E+01 -1.00445349690E+01 -1.00445149922E+01 -1.00444943367E+01 -1.00444729793E+01 -1.00444508963E+01 -1.00444280630E+01 -1.00444044541E+01 -1.00443800430E+01 -1.00443548030E+01 -1.00443287055E+01 -1.00443017219E+01 -1.00442738218E+01 -1.00442449744E+01 -1.00442151474E+01 -1.00441843079E+01 -1.00441524212E+01 -1.00441194522E+01 -1.00440853639E+01 -1.00440501189E+01 -1.00440136774E+01 -1.00439759995E+01 -1.00439370427E+01 -1.00438967644E+01 -1.00438551192E+01 -1.00438120615E+01 -1.00437675428E+01 -1.00437215143E+01 -1.00436739243E+01 -1.00436247206E+01 -1.00435738480E+01 -1.00435212507E+01 -1.00434668697E+01 -1.00434106453E+01 -1.00433525145E+01 -1.00432924137E+01 -1.00432302754E+01 -1.00431660316E+01 -1.00430996103E+01 -1.00430309388E+01 -1.00429599401E+01 -1.00428865367E+01 -1.00428106463E+01 -1.00427321860E+01 -1.00426510679E+01 -1.00425672034E+01 -1.00424804987E+01 -1.00423908592E+01 -1.00422981846E+01 -1.00422023739E+01 -1.00421033198E+01 -1.00420009146E+01 -1.00418950437E+01 -1.00417855919E+01 -1.00416724370E+01 -1.00415554558E+01 -1.00414345179E+01 -1.00413094917E+01 -1.00411802379E+01 -1.00410466160E+01 -1.00409084773E+01 -1.00407656716E+01 -1.00406180404E+01 -1.00404654231E+01 -1.00403076505E+01 -1.00401445513E+01 -1.00399759446E+01 -1.00398016478E+01 -1.00396214676E+01 -1.00394352090E+01 -1.00392426660E+01 -1.00390436303E+01 -1.00388378819E+01 -1.00386251986E+01 -1.00384053457E+01 -1.00381780861E+01 -1.00379431692E+01 -1.00377003422E+01 -1.00374493376E+01 -1.00371898856E+01 -1.00369217011E+01 -1.00366444962E+01 -1.00363579667E+01 -1.00360618058E+01 -1.00357556889E+01 -1.00354392887E+01 -1.00351122594E+01 -1.00347742519E+01 -1.00344248974E+01 -1.00340638240E+01 -1.00336906386E+01 -1.00333049447E+01 -1.00329063233E+01 -1.00324943521E+01 -1.00320685847E+01 -1.00316285711E+01 -1.00311738359E+01 -1.00307038997E+01 -1.00302182563E+01 -1.00297163954E+01 -1.00291977778E+01 -1.00286618605E+01 -1.00281080696E+01 -1.00275358271E+01 -1.00269445226E+01 -1.00263335412E+01 -1.00257022335E+01 -1.00250499456E+01 -1.00243759871E+01 -1.00236796629E+01 -1.00229602393E+01 -1.00222169774E+01 -1.00214490978E+01 -1.00206558158E+01 -1.00198363036E+01 -1.00189897283E+01 -1.00181152110E+01 -1.00172118679E+01 -1.00162787667E+01 -1.00153149700E+01 -1.00143194894E+01 -1.00132913311E+01 -1.00122294478E+01 -1.00111327869E+01 -1.00100002392E+01 -1.00088306904E+01 -1.00076229666E+01 -1.00063758892E+01 -1.00050882168E+01 -1.00037587037E+01 -1.00023860381E+01 -1.00009689044E+01 -9.99950591773E+00 -9.99799568991E+00 -9.99643676038E+00 -9.99482766575E+00 -9.99316686712E+00 -9.99145282352E+00 -9.98968391526E+00 -9.98785852155E+00 -9.98597493969E+00 -9.98403146703E+00 -9.98202631590E+00 -9.97995770006E+00 -9.97782374523E+00 -9.97562258020E+00 -9.97335224284E+00 -9.97101077598E+00 -9.96859612890E+00 -9.96610625802E+00 -9.96353902379E+00 -9.96089229639E+00 -9.95816384784E+00 -9.95535146289E+00 -9.95245282637E+00 -9.94946563918E+00 -9.94638750093E+00 -9.94321603122E+00 -9.93994874745E+00 -9.93658319134E+00 -9.93311680216E+00 -9.92954704832E+00 -9.92587129620E+00 -9.92208694668E+00 -9.91819129975E+00 -9.91418169578E+00 -9.91005537628E+00 -9.90580962952E+00 -9.90144164782E+00 -9.89694867719E+00 -9.89232787153E+00 -9.88757644580E+00 -9.88269152778E+00 -9.87767031401E+00 -9.87250991978E+00 -9.86720753716E+00 -9.86176028393E+00 -9.85616536272E+00 -9.85041990980E+00 -9.84452115427E+00 -9.83846626769E+00 -9.83225252188E+00 -9.82587714078E+00 -9.81933745512E+00 -9.81263075786E+00 -9.80575445395E+00 -9.79870592083E+00 -9.79148265113E+00 -9.78408211993E+00 -9.77650191794E+00 -9.76873962737E+00 -9.76079294282E+00 -9.75265955782E+00 -9.74433727027E+00 -9.73582388189E+00 -9.72711728467E+00 -9.71821537564E+00 -9.70911612055E+00 -9.69981748643E+00 -9.69031747829E+00 -9.68061409218E+00 -9.67070532051E+00 -9.66058912826E+00 -9.65026342224E+00 -9.63972605332E+00 -9.62897474478E+00 -9.61800712345E+00 -9.60682060225E+00 -9.59541244310E+00 -9.58377958909E+00 -9.57191876191E+00 -9.55982623935E+00 -9.54749799015E+00 -9.53492939329E+00 -9.52211541300E+00 -9.50905025740E+00 -9.49572759661E+00 -9.48214015983E+00 -9.46827999954E+00 -9.45413802851E+00 -9.43970433336E+00 -9.42496765588E+00 -9.40991575995E+00 -9.39453486539E+00 -9.37881007308E+00 -9.36272476464E+00 -9.34626109197E+00 -9.32939936179E+00 -9.31211859807E+00 -9.29439593737E+00 -9.27620727498E+00 -9.25752670458E+00 -9.23832726160E+00 -9.21858044834E+00 -9.19825708965E+00 -9.17732699041E+00 -9.15575991768E+00 -9.13352543826E+00 -9.11059403341E+00 -9.08693715491E+00 -9.06252845670E+00 -9.03734407974E+00 -9.01136393895E+00 -8.98457218799E+00 -8.95695841638E+00 -8.92851814104E+00 -8.89925363301E+00 -8.86917412270E+00 -8.83829578111E+00 -8.80664111108E+00 -8.77423736438E+00 -8.74111434333E+00 -8.70730027209E+00 -8.67281699035E+00 -8.63767205619E+00 -8.60185012756E+00 -8.56529995865E+00 -8.52792089452E+00 -8.48954409659E+00 -8.44991502190E+00 -8.40867272666E+00 -8.36533836867E+00 -8.31931319696E+00 -8.26991045616E+00 -8.21643284838E+00 -8.15833747662E+00 -8.09551121747E+00 -8.02873062855E+00 -7.96089422471E+00 -7.89606641939E+00 -7.83446112874E+00 -7.77285335784E+00 -7.70990449773E+00 -7.64590018265E+00 -7.58085576761E+00 -7.51475774011E+00 -7.44758905150E+00 -7.37932828626E+00 -7.30994705090E+00 -7.23941231736E+00 -7.16768328926E+00 -7.09471236263E+00 -7.02044047525E+00 -6.94479594249E+00 -6.86768868330E+00 -6.78900941101E+00 -6.70862855814E+00 -6.62640520202E+00 -6.54220191013E+00 -6.45591124938E+00 -6.36748308145E+00 -6.27694603039E+00 -6.18440359935E+00 -6.08999414890E+00 -5.99380405252E+00 -5.89576426859E+00 -5.79529169941E+00 -5.69129877133E+00 -5.58422256840E+00 -5.47704687294E+00 -5.37228693533E+00 -5.27031449516E+00 -5.17100995587E+00 -5.07453328432E+00 -4.98109768680E+00 -4.89098944819E+00 -4.80456853827E+00 -4.72226252280E+00 -4.64390439619E+00 -4.56690951148E+00 -4.49122273752E+00 -4.41681711982E+00 -4.34366754757E+00 -4.27174952980E+00 -4.20103960015E+00 -4.13151479323E+00 -4.06315322348E+00 -3.99593340728E+00 -3.92983476540E+00 -3.86483708938E+00 -3.80092092786E+00 -3.73806717413E+00 -3.67625735884E+00 -3.61547333519E+00 -3.55569749752E+00 -3.49691254375E+00 -3.43910163642E+00 -3.38224822517E+00 -3.32633616385E+00 -3.27134957902E+00 -3.21727295403E+00 -3.16409103218E+00 -3.11178887648E+00 -3.06035179874E+00 -3.00976539962E+00 -2.96001552235E+00 -2.91108827472E+00 -2.86296999062E+00 -2.81564726014E+00 -2.76910688881E+00 -2.72333591865E+00 -2.67832160365E+00 -2.63405142026E+00 -2.59051305006E+00 -2.54769438643E+00 -2.50558352108E+00 -2.46416874833E+00 -2.42343855439E+00 -2.38338161988E+00 -2.34398681115E+00 -2.30524318148E+00 -2.26713996400E+00 -2.22966657187E+00 -2.19281259237E+00 -2.15656778638E+00 -2.12092208327E+00 -2.08586558009E+00 -2.05138853679E+00 -2.01748137543E+00 -1.98413467530E+00 -1.95133917247E+00 -1.91908575631E+00 -1.88736546667E+00 -1.85616948945E+00 -1.82548915957E+00 -1.79531595240E+00 -1.76564148620E+00 -1.73645751580E+00 -1.70775593426E+00 -1.67952876655E+00 -1.65176817146E+00 -1.62446643534E+00 -1.59761597402E+00 -1.57120932670E+00 -1.54523915786E+00 -1.51969825135E+00 -1.49457951214E+00 -1.46987596079E+00 -1.44558073492E+00 -1.42168708410E+00 -1.39818837093E+00 -1.37507806651E+00 -1.35234975111E+00 -1.32999711006E+00 -1.30801393412E+00 -1.28639411586E+00 -1.26513164962E+00 -1.24422062832E+00 -1.22365524323E+00 -1.20342978103E+00 -1.18353862341E+00 -1.16397624444E+00 -1.14473720996E+00 -1.12581617528E+00 -1.10720788433E+00 -1.08890716767E+00 -1.07090894151E+00 -1.05320820590E+00 -1.03580004368E+00 -1.01867961882E+00 -1.00184217533E+00 -9.85283035742E-01 -9.68997599958E-01 -9.52981343853E-01 -9.37229818132E-01 -9.21738646992E-01 -9.06503526998E-01 -8.91520225812E-01 -8.76784581080E-01 -8.62292499229E-01 -8.48039954366E-01 -8.34022987132E-01 -8.20237703627E-01 -8.06680274305E-01 -7.93346932931E-01 -7.80233975521E-01 -7.67337759321E-01 -7.54654701787E-01 -7.42181279600E-01 -7.29914027677E-01 -7.17849538216E-01 -7.05984459743E-01 -6.94315496187E-01 -6.82839405958E-01 -6.71553001050E-01 -6.60453146155E-01 -6.49536757788E-01 -6.38800803438E-01 -6.28242300717E-01 -6.17858316535E-01 -6.07645966288E-01 -5.97602413049E-01 -5.87724866788E-01 -5.78010583590E-01 -5.68456864897E-01 -5.59061056756E-01 -5.49820549084E-01 -5.40732774938E-01 -5.31795209807E-01 -5.23005370911E-01 -5.14360816521E-01 -5.05859145118E-01 -4.97497995379E-01 -4.89275044138E-01 -4.81188007641E-01 -4.73234638966E-01 -4.65412728910E-01 -4.57720104619E-01 -4.50154629157E-01 -4.42714200906E-01 -4.35396752988E-01 -4.28200252689E-01 -4.21122700891E-01 -4.14162131523E-01 -4.07316611010E-01 -4.00584237735E-01 -3.93963141515E-01 -3.87451483079E-01 -3.81047453557E-01 -3.74749273978E-01 -3.68555194775E-01 -3.62463495299E-01 -3.56472483344E-01 -3.50580494671E-01 -3.44785892552E-01 -3.39087067311E-01 -3.33482435878E-01 -3.27970441349E-01 -3.22549552556E-01 -3.17218263637E-01 -3.11975093621E-01 -3.06818586018E-01 -3.01747308408E-01 -2.96759852051E-01 -2.91854831490E-01 -2.87030884168E-01 -2.82286670051E-01 -2.77620871251E-01 -2.73032191667E-01 -2.68519356619E-01 -2.64081112496E-01 -2.59716226408E-01 -2.55423485843E-01 -2.51201698331E-01 -2.47049691111E-01 -2.42966310808E-01 -2.38950423109E-01 -2.35000912451E-01 -2.31116681710E-01 -2.27296651896E-01 -2.23539761856E-01 -2.19844967919E-01 -2.16211243934E-01 -2.12637580214E-01 -2.09122984145E-01 -2.05666479440E-01 -2.02267105928E-01 -1.98923919307E-01 -1.95635990880E-01 -1.92402407303E-01 -1.89222270329E-01 -1.86094696557E-01 -1.83018817188E-01 -1.79993777783E-01 -1.77018738027E-01 -1.74092871494E-01 -1.71215365417E-01 -1.68385420464E-01 -1.65602250513E-01 -1.62865082438E-01 -1.60173155892E-01 -1.57525723093E-01 -1.54922048620E-01 -1.52361409209E-01 -1.49843093549E-01 -1.47366402086E-01 -1.44930646830E-01 -1.42535151161E-01 -1.40179249644E-01 -1.37862287842E-01 -1.35583622136E-01 -1.33342619544E-01 -1.31138657546E-01 -1.28971123913E-01 -1.26839416534E-01 -1.24742943251E-01 -1.22681121694E-01 -1.20653379117E-01 -1.18659152242E-01 -1.16697887101E-01 -1.14769038883E-01 -1.12872071781E-01 -1.11006458844E-01 -1.09171681832E-01 -1.07367231070E-01 -1.05592605308E-01 -1.03847311579E-01 -1.02130865067E-01 -1.00442788967E-01 -9.87826143559E-02 -9.71498800615E-02 -9.55441325335E-02 -9.39649257187E-02 -9.24118209363E-02 -9.08843867563E-02 -8.93821988797E-02 -8.79048400206E-02 -8.64518997903E-02 -8.50229745833E-02 -8.36176674649E-02 -8.22355880616E-02 -8.08763524517E-02 -7.95395830598E-02 -7.82249085509E-02 -7.69319637278E-02 -7.56603894294E-02 -7.44098324312E-02 -7.31799453470E-02 -7.19703865322E-02 -7.07808199894E-02 -6.96109152746E-02 -6.84603474057E-02 -6.73287967719E-02 -6.62159490453E-02 -6.51214950935E-02 -6.40451308934E-02 -6.29865574471E-02 -6.19454806986E-02 -6.09216114525E-02 -5.99146652931E-02 -5.89243625060E-02 -5.79504279997E-02 -5.69925912300E-02 -5.60505861242E-02 -5.51241510073E-02 -5.42130285297E-02 -5.33169655952E-02 -5.24357132910E-02 -5.15690268186E-02 -5.07166654255E-02 -4.98783923386E-02 -4.90539746982E-02 -4.82431834937E-02 -4.74457934995E-02 -4.66615832128E-02 -4.58903347917E-02 -4.51318339953E-02 -4.43858701234E-02 -4.36522359587E-02 -4.29307277086E-02 -4.22211449493E-02 -4.15232905694E-02 -4.08369707155E-02 -4.01619947386E-02 -3.94981751404E-02 -3.88453275222E-02 1 0 Beta L 627 0.00000000000E+00 -2.09375820207E-06 -4.22221766152E-06 -6.39530162111E-06 -8.59336153065E-06 -1.08288452744E-05 -1.31103611755E-05 -1.54178330609E-05 -1.77931496785E-05 -2.01548697189E-05 -2.26239225813E-05 -2.50536869338E-05 -2.76184779251E-05 -3.01448860555E-05 -3.27658136745E-05 -3.53811477132E-05 -3.81207486948E-05 -4.08115987160E-05 -4.35973630944E-05 -4.64310379064E-05 -4.93203016548E-05 -5.22450939689E-05 -5.51894282769E-05 -5.82127514428E-05 -6.13265033662E-05 -6.44166464143E-05 -6.76156950552E-05 -7.07951031568E-05 -7.41577523396E-05 -7.74379149249E-05 -8.08579204558E-05 -8.43237254442E-05 -8.77930097488E-05 -9.14238747370E-05 -9.49913302306E-05 -9.87277620154E-05 -1.02458658077E-04 -1.06277890556E-04 -1.10187004195E-04 -1.14088395879E-04 -1.18128884902E-04 -1.22200849609E-04 -1.26355681712E-04 -1.30559506019E-04 -1.34851850496E-04 -1.39229994212E-04 -1.43640331542E-04 -1.48157711201E-04 -1.52766191857E-04 -1.57388382207E-04 -1.62164334726E-04 -1.66955999511E-04 -1.71858773825E-04 -1.76857346551E-04 -1.81915063335E-04 -1.87074391551E-04 -1.92318529386E-04 -1.97601887385E-04 -2.03081019885E-04 -2.08531536058E-04 -2.14170779836E-04 -2.19862027188E-04 -2.25609244357E-04 -2.31537078213E-04 -2.37512336634E-04 -2.43596666807E-04 -2.49797081263E-04 -2.56074684969E-04 -2.62460938177E-04 -2.69007555575E-04 -2.75589129257E-04 -2.82308098316E-04 -2.89174747588E-04 -2.96128397537E-04 -3.03178903501E-04 -3.10389618375E-04 -3.17686691699E-04 -3.25088265168E-04 -3.32732794067E-04 -3.40340586759E-04 -3.48201991048E-04 -3.56101077122E-04 -3.64232045056E-04 -3.72412502576E-04 -3.80783330135E-04 -3.89274549841E-04 -3.97911044465E-04 -4.06675323733E-04 -4.15628785086E-04 -4.24698068048E-04 -4.33937554897E-04 -4.43318790107E-04 -4.52850205175E-04 -4.62586852829E-04 -4.72429736229E-04 -4.82474719231E-04 -4.92673703315E-04 -5.03059670197E-04 -5.13582518161E-04 -5.24349110595E-04 -5.35212457316E-04 -5.46330885864E-04 -5.57596951251E-04 -5.69069528644E-04 -5.80710608541E-04 -5.92581745583E-04 -6.04633535207E-04 -6.16884754261E-04 -6.29352621416E-04 -6.42015770015E-04 -6.54903317094E-04 -6.68002955967E-04 -6.81333942143E-04 -6.94878525027E-04 -7.08618160199E-04 -7.22683116843E-04 -7.36871710345E-04 -7.51365898474E-04 -7.66098439223E-04 -7.81052925746E-04 -7.96284727465E-04 -8.11755574459E-04 -8.27491613147E-04 -8.43509584138E-04 -8.59755427135E-04 -8.76320093626E-04 -8.93134284430E-04 -9.10233719169E-04 -9.27631019721E-04 -9.45327153463E-04 -9.63283394555E-04 -9.81585882516E-04 -1.00017233995E-03 -1.01908197664E-03 -1.03829701555E-03 -1.05783457939E-03 -1.07772777817E-03 -1.09791566984E-03 -1.11846843369E-03 -1.13936789749E-03 -1.16060087153E-03 -1.18220279411E-03 -1.20416826167E-03 -1.22649974600E-03 -1.24921175534E-03 -1.27229300338E-03 -1.29577188951E-03 -1.31964528517E-03 -1.34392549577E-03 -1.36859178843E-03 -1.39369818501E-03 -1.41921025755E-03 -1.44516252156E-03 -1.47153668011E-03 -1.49836720775E-03 -1.52564543267E-03 -1.55337693220E-03 -1.58157821166E-03 -1.61026204445E-03 -1.63940119509E-03 -1.66907010025E-03 -1.69919585400E-03 -1.72985802992E-03 -1.76102226566E-03 -1.79271290328E-03 -1.82494233670E-03 -1.85769668993E-03 -1.89102320001E-03 -1.92489130911E-03 -1.95933743406E-03 -1.99437001743E-03 -2.02996870091E-03 -2.06618287663E-03 -2.10301283203E-03 -2.14044090738E-03 -2.17851504021E-03 -2.21721123249E-03 -2.25658331795E-03 -2.29659375952E-03 -2.33728705166E-03 -2.37866488993E-03 -2.42073784937E-03 -2.46350888240E-03 -2.50701397129E-03 -2.55123006108E-03 -2.59622110024E-03 -2.64193405641E-03 -2.68842887141E-03 -2.73571653154E-03 -2.78377302871E-03 -2.83266979075E-03 -2.88235909736E-03 -2.93289939221E-03 -2.98428486568E-03 -3.03653323736E-03 -3.08966947556E-03 -3.14367322759E-03 -3.19861213119E-03 -3.25446567228E-03 -3.31125051623E-03 -3.36899549021E-03 -3.42771381883E-03 -3.48741010754E-03 -3.54812177392E-03 -3.60983825808E-03 -3.67260981915E-03 -3.73642312684E-03 -3.80131283280E-03 -3.86729726583E-03 -3.93437983701E-03 -4.00260150573E-03 -4.07196665331E-03 -4.14249091330E-03 -4.21420736536E-03 -4.28712717794E-03 -4.36127286886E-03 -4.43666689848E-03 -4.51332022587E-03 -4.59126742264E-03 -4.67052887369E-03 -4.75111146599E-03 -4.83306208527E-03 -4.91637262478E-03 -5.00110020998E-03 -5.08724554826E-03 -5.17482882484E-03 -5.26390294126E-03 -5.35445961566E-03 -5.44654082340E-03 -5.54017561795E-03 -5.63537667014E-03 -5.73218074606E-03 -5.83061265434E-03 -5.93069880229E-03 -6.03246323869E-03 -6.13594371992E-03 -6.24115836813E-03 -6.34814524203E-03 -6.45692448744E-03 -6.56754058174E-03 -6.68000619025E-03 -6.79436892853E-03 -6.91065008192E-03 -7.02888581675E-03 -7.14910909051E-03 -7.27135558689E-03 -7.39565129515E-03 -7.52203820095E-03 -7.65055005474E-03 -7.78122271830E-03 -7.91408741978E-03 -8.04918900404E-03 -8.18655725725E-03 -8.32623963346E-03 -8.46826170894E-03 -8.61267944121E-03 -8.75951725875E-03 -8.90882541557E-03 -9.06064257354E-03 -9.21501359376E-03 -9.37197180022E-03 -9.53157647511E-03 -9.69385890102E-03 -9.85886691081E-03 -1.00266516687E-02 -1.01972547958E-02 -1.03707243564E-02 -1.05471099316E-02 -1.07264587736E-02 -1.09088220751E-02 -1.10942511362E-02 -1.12827947732E-02 -1.14745091615E-02 -1.16694415842E-02 -1.18676538809E-02 -1.20691938440E-02 -1.22741235381E-02 -1.24824956659E-02 -1.26943680975E-02 -1.29098053672E-02 -1.31288573358E-02 -1.33515964216E-02 -1.35780735504E-02 -1.38083580477E-02 -1.40425162243E-02 -1.42806017924E-02 -1.45226956394E-02 -1.47688535933E-02 -1.50191490691E-02 -1.52736515375E-02 -1.55324298130E-02 -1.57955567261E-02 -1.60631050432E-02 -1.63351499660E-02 -1.66117667210E-02 -1.68930307449E-02 -1.71790210868E-02 -1.74698177420E-02 -1.77655011569E-02 -1.80661518883E-02 -1.83718563501E-02 -1.86826963311E-02 -1.89987601566E-02 -1.93201344278E-02 -1.96469098507E-02 -1.99791739895E-02 -2.03170236766E-02 -2.06605488461E-02 -2.10098461574E-02 -2.13650135530E-02 -2.17261470749E-02 -2.20933498897E-02 -2.24667219830E-02 -2.28463673328E-02 -2.32323920971E-02 -2.36249013735E-02 -2.40240084342E-02 -2.44298170683E-02 -2.48424474438E-02 -2.52620083375E-02 -2.56886188647E-02 -2.61223968078E-02 -2.65634629550E-02 -2.70119377034E-02 -2.74679496757E-02 -2.79316199374E-02 -2.84030810601E-02 -2.88824623118E-02 -2.93698967752E-02 -2.98655200266E-02 -3.03694690503E-02 -3.08818836345E-02 -3.14029057831E-02 -3.19326807965E-02 -3.24713538657E-02 -3.30190765442E-02 -3.35759981968E-02 -3.41422750725E-02 -3.47180637749E-02 -3.53035234647E-02 -3.58988151496E-02 -3.65041074637E-02 -3.71195638825E-02 -3.77453576539E-02 -3.83816611898E-02 -3.90286503979E-02 -3.96865057879E-02 -4.03554083744E-02 -4.10355424228E-02 -4.17270995081E-02 -4.24302675077E-02 -4.31452439657E-02 -4.38722239765E-02 -4.46114110834E-02 -4.53630089155E-02 -4.61272258095E-02 -4.69042718192E-02 -4.76943636426E-02 -4.84977187202E-02 -4.93145596954E-02 -5.01451121869E-02 -5.09896055030E-02 -5.18482738360E-02 -5.27213536243E-02 -5.36090864082E-02 -5.45117179856E-02 -5.54294963585E-02 -5.63626762325E-02 -5.73115146736E-02 -5.82762733768E-02 -5.92572190002E-02 -6.02546220210E-02 -6.12687571170E-02 -6.22999051394E-02 -6.33483489358E-02 -6.44143781657E-02 -6.54982869001E-02 -6.66003728263E-02 -6.77209407567E-02 -6.88602975236E-02 -7.00187583107E-02 -7.11966408587E-02 -7.23942694657E-02 -7.36119734037E-02 -7.48500874752E-02 -7.61089514750E-02 -7.73889118968E-02 -7.86903195157E-02 -8.00135315970E-02 -8.13589111572E-02 -8.27268276442E-02 -8.41176546885E-02 -8.55317752338E-02 -8.69695744405E-02 -8.84314473927E-02 -8.99177933267E-02 -9.14290187277E-02 -9.29655362335E-02 -9.45277664595E-02 -9.61161346916E-02 -9.77310745733E-02 -9.93730266248E-02 -1.01042438252E-01 -1.02739763243E-01 -1.04465464124E-01 -1.06220009696E-01 -1.08003876656E-01 -1.09817549253E-01 -1.11661519539E-01 -1.13536286866E-01 -1.15442359462E-01 -1.17380252388E-01 -1.19350490037E-01 -1.21353603800E-01 -1.23390134726E-01 -1.25460630976E-01 -1.27565650452E-01 -1.29705758812E-01 -1.31881531522E-01 -1.34093551442E-01 -1.36342411887E-01 -1.38628714655E-01 -1.40953070646E-01 -1.43316100265E-01 -1.45718433576E-01 -1.48160709567E-01 -1.50643577395E-01 -1.53167696081E-01 -1.55733733844E-01 -1.58342369382E-01 -1.60994291655E-01 -1.63690198738E-01 -1.66430800491E-01 -1.69216815539E-01 -1.72048974364E-01 -1.74928016872E-01 -1.77854694071E-01 -1.80829767792E-01 -1.83854010386E-01 -1.86928205061E-01 -1.90053145919E-01 -1.93229638397E-01 -1.96458498506E-01 -1.99740553338E-01 -2.03076641891E-01 -2.06467613176E-01 -2.09914328486E-01 -2.13417659433E-01 -2.16978489814E-01 -2.20597713906E-01 -2.24276237642E-01 -2.28014978108E-01 -2.31814863668E-01 -2.35676833786E-01 -2.39601839278E-01 -2.43590841546E-01 -2.47644813734E-01 -2.51764739246E-01 -2.55951612560E-01 -2.60206438898E-01 -2.64530233780E-01 -2.68924023391E-01 -2.73388843539E-01 -2.77925740807E-01 -2.82535770632E-01 -2.87219998493E-01 -2.91979498646E-01 -2.96815354384E-01 -3.01728657387E-01 -3.06720507444E-01 -3.11792011714E-01 -3.16944285064E-01 -3.22178448201E-01 -3.27495628851E-01 -3.32896959335E-01 -3.38383577279E-01 -3.43956624457E-01 -3.49617245464E-01 -3.55366587911E-01 -3.61205800657E-01 -3.67136033149E-01 -3.73158434649E-01 -3.79274152300E-01 -3.85484330957E-01 -3.91790110939E-01 -3.98192627135E-01 -4.04693007329E-01 -4.11292370561E-01 -4.17991825350E-01 -4.24792467900E-01 -4.31695379930E-01 -4.38701626511E-01 -4.45812254068E-01 -4.53028287213E-01 -4.60350726751E-01 -4.67780546405E-01 -4.75318689725E-01 -4.82966067104E-01 -4.90723551867E-01 -4.98591976624E-01 -5.06572129445E-01 -5.14664748783E-01 -5.22870519946E-01 -5.31190069108E-01 -5.39623958281E-01 -5.48172679701E-01 -5.56836649822E-01 -5.65616202033E-01 -5.74511580883E-01 -5.83522933024E-01 -5.92650300385E-01 -6.01893611015E-01 -6.11252669585E-01 -6.20727148248E-01 -6.30316574946E-01 -6.40020323162E-01 -6.49837598964E-01 -6.59767428194E-01 -6.69808642822E-01 -6.79959865389E-01 -6.90219493863E-01 -7.00585683376E-01 -7.11056329412E-01 -7.21629046735E-01 -7.32301149476E-01 -7.43069628321E-01 -7.53931126556E-01 -7.64881914570E-01 -7.75917862651E-01 -7.87034411521E-01 -7.98226541389E-01 -8.09488738894E-01 -8.20814961483E-01 -8.32198599723E-01 -8.43632437591E-01 -8.55108609550E-01 -8.66618555407E-01 -8.78152972344E-01 -8.89701764412E-01 -9.01253988260E-01 -9.12797797226E-01 -9.24320380865E-01 -9.35807902656E-01 -9.47245434159E-01 -9.58616885782E-01 -9.69904935413E-01 -9.81090953429E-01 -9.92154925739E-01 -1.00307537412E+00 -1.01382927443E+00 -1.02439197383E+00 -1.03473710674E+00 -1.04483651008E+00 -1.05466014033E+00 -1.06417599104E+00 -1.07335001392E+00 -1.08214604443E+00 -1.09052573298E+00 -1.09844848453E+00 -1.10587140919E+00 -1.11274928444E+00 -1.11903453523E+00 -1.12467723205E+00 -1.12962511307E+00 -1.13382363364E+00 -1.13721604729E+00 -1.13974352444E+00 -1.14134531335E+00 -1.14195894862E+00 -1.14152051506E+00 -1.13996497004E+00 -1.13722653392E+00 -1.13323915090E+00 -1.12793702874E+00 -1.12125525951E+00 -1.11313052607E+00 -1.10350189566E+00 -1.09231169866E+00 -1.07950649082E+00 -1.06503808795E+00 -1.04886466450E+00 -1.03095189238E+00 -1.01127409956E+00 -9.89815410279E-01 -9.66570826605E-01 -9.41547196873E-01 -9.14764007963E-01 -8.86253926547E-01 -8.56063006454E-01 -8.24250471844E-01 -7.90887983134E-01 -7.56058301018E-01 -7.19853279033E-01 -6.82371154404E-01 -6.43713166975E-01 -6.03979638750E-01 -5.63265794676E-01 -5.21657831907E-01 -4.79230059174E-01 -4.36044381221E-01 -3.92154017672E-01 -3.47614200949E-01 -3.02503739394E-01 -2.56962876898E-01 -2.11254926023E-01 -1.65861855174E-01 -1.21627627585E-01 -7.99671801831E-02 -4.31703526557E-02 -1.47861174876E-02 -5.82615052525E-04 -4.69443491925E-05 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2 0 Beta L 627 0.00000000000E+00 4.55982034549E-06 9.19908081851E-06 1.38500238368E-05 1.86691888517E-05 2.35580743561E-05 2.84783174735E-05 3.35542833448E-05 3.85277154651E-05 4.39508562971E-05 4.90042812282E-05 5.46720712483E-05 5.98225317231E-05 6.56044835053E-05 7.11080819794E-05 7.70909220508E-05 8.25700987265E-05 8.88313703529E-05 9.48353602424E-05 1.00933302946E-04 1.07099192404E-04 1.13443329928E-04 1.20090916682E-04 1.26658991630E-04 1.33061430860E-04 1.40094968471E-04 1.46853162368E-04 1.54219771201E-04 1.60844931982E-04 1.68511840503E-04 1.75727316911E-04 1.83173198562E-04 1.91069288332E-04 1.98435064084E-04 2.06759647999E-04 2.14469930481E-04 2.22796295449E-04 2.31072788552E-04 2.39321019278E-04 2.48192198721E-04 2.56737556248E-04 2.65653110353E-04 2.74632697711E-04 2.83898554100E-04 2.93200584532E-04 3.02566194042E-04 3.12368506531E-04 3.22126760879E-04 3.31912773974E-04 3.42328038613E-04 3.52380602731E-04 3.63070989248E-04 3.73684772404E-04 3.84440109050E-04 3.95496510859E-04 4.06655997922E-04 4.18013252259E-04 4.29878944636E-04 4.41230380307E-04 4.53592427983E-04 4.65490768401E-04 4.77895660082E-04 4.90763089516E-04 5.03291093106E-04 5.16367123952E-04 5.29627008228E-04 5.42994185290E-04 5.56768251828E-04 5.70771420768E-04 5.84651786986E-04 5.99245608290E-04 6.13921988837E-04 6.28617014243E-04 6.43744674061E-04 6.59244479046E-04 6.74756437817E-04 6.90728137423E-04 7.07129677782E-04 7.22969091959E-04 7.40204600557E-04 7.56902633618E-04 7.74475791581E-04 7.91710000173E-04 8.09808020518E-04 8.27858828456E-04 8.46342355312E-04 8.65121691807E-04 8.84340785090E-04 9.03594167744E-04 9.23405405271E-04 9.43431807860E-04 9.63877304797E-04 9.84733205593E-04 1.00561958504E-03 1.02725326305E-03 1.04900141843E-03 1.07121913416E-03 1.09369243114E-03 1.11680753694E-03 1.13986508772E-03 1.16386396813E-03 1.18778214471E-03 1.21237664627E-03 1.23725769887E-03 1.26272351613E-03 1.28838086130E-03 1.31461047842E-03 1.34129026672E-03 1.36834536230E-03 1.39595547105E-03 1.42395151389E-03 1.45244698763E-03 1.48134940913E-03 1.51079976842E-03 1.54097547192E-03 1.57101529886E-03 1.60231562550E-03 1.63369888702E-03 1.66564546962E-03 1.69828868367E-03 1.73131795788E-03 1.76501335670E-03 1.79924073958E-03 1.83391820371E-03 1.86947125201E-03 1.90530246846E-03 1.94192679830E-03 1.97916209799E-03 2.01694060155E-03 2.05531856930E-03 2.09458717219E-03 2.13422281524E-03 2.17467407205E-03 2.21573981696E-03 2.25757786869E-03 2.30011792449E-03 2.34319772594E-03 2.38725794268E-03 2.43189378826E-03 2.47727258248E-03 2.52352272519E-03 2.57047963518E-03 2.61821798818E-03 2.66677774425E-03 2.71612294529E-03 2.76637959024E-03 2.81741775321E-03 2.86930632901E-03 2.92203726980E-03 2.97579892296E-03 3.03029490041E-03 3.08580970759E-03 3.14219156979E-03 3.19960348017E-03 3.25790669417E-03 3.31719863290E-03 3.37752637738E-03 3.43884669153E-03 3.50113623640E-03 3.56465138487E-03 3.62896735003E-03 3.69464649769E-03 3.76121996267E-03 3.82900893618E-03 3.89791522356E-03 3.96794128186E-03 4.03925210591E-03 4.11162185491E-03 4.18532288106E-03 4.26021663690E-03 4.33630177622E-03 4.41383386609E-03 4.49254307739E-03 4.57253020378E-03 4.65400316805E-03 4.73672546026E-03 4.82096869716E-03 4.90644295020E-03 4.99351992310E-03 5.08198420436E-03 5.17193586091E-03 5.26339916324E-03 5.35645851382E-03 5.45098121618E-03 5.54722953901E-03 5.64487746794E-03 5.74439884263E-03 5.84550005631E-03 5.94822634530E-03 6.05284990673E-03 6.15901353429E-03 6.26715962021E-03 6.37701176967E-03 6.48874395583E-03 6.60235393108E-03 6.71781097525E-03 6.83537739873E-03 6.95473549959E-03 7.07615790317E-03 7.19967213070E-03 7.32521774495E-03 7.45285956163E-03 7.58270367091E-03 7.71464910722E-03 7.84891553907E-03 7.98531894925E-03 8.12410272590E-03 8.26519491058E-03 8.40862562674E-03 8.55454305616E-03 8.70283322228E-03 8.85363402016E-03 9.00701765717E-03 9.16292805440E-03 9.32147624858E-03 9.48268000095E-03 9.64658385669E-03 9.81329043782E-03 9.98276294614E-03 1.01550529508E-02 1.03303145937E-02 1.05084255901E-02 1.06896501317E-02 1.08738025285E-02 1.10610933083E-02 1.12515970396E-02 1.14451758239E-02 1.16421036736E-02 1.18423224869E-02 1.20458674503E-02 1.22528794059E-02 1.24633518288E-02 1.26773528479E-02 1.28949522136E-02 1.31162314340E-02 1.33411905804E-02 1.35699637364E-02 1.38025542926E-02 1.40390900948E-02 1.42795427544E-02 1.45240996611E-02 1.47727189326E-02 1.50255386920E-02 1.52826055012E-02 1.55439871012E-02 1.58097442951E-02 1.60799997042E-02 1.63547817111E-02 1.66341767611E-02 1.69182543598E-02 1.72071370484E-02 1.75008440339E-02 1.77995124799E-02 1.81031618478E-02 1.84119645235E-02 1.87258972184E-02 1.90451504715E-02 1.93697493791E-02 1.96998043979E-02 2.00353872173E-02 2.03766561511E-02 2.07236007205E-02 2.10764027346E-02 2.14351458229E-02 2.17998868405E-02 2.21707681635E-02 2.25478820114E-02 2.29313265836E-02 2.33212195612E-02 2.37176584521E-02 2.41207499635E-02 2.45306237549E-02 2.49473674939E-02 2.53711364318E-02 2.58019974219E-02 2.62401173962E-02 2.66855774123E-02 2.71385292293E-02 2.75990987968E-02 2.80673736614E-02 2.85435520675E-02 2.90276886641E-02 2.95199890051E-02 3.00205477364E-02 3.05294873852E-02 3.10470238887E-02 3.15732027450E-02 3.21082449914E-02 3.26522654055E-02 3.32054145954E-02 3.37678580274E-02 3.43397448822E-02 3.49212347233E-02 3.55124844928E-02 3.61136557586E-02 3.67249281883E-02 3.73464620064E-02 3.79784256321E-02 3.86209956482E-02 3.92743599859E-02 3.99386796198E-02 4.06141583902E-02 4.13009695458E-02 4.19993105550E-02 4.27093635688E-02 4.34313467375E-02 4.41654276247E-02 4.49118349705E-02 4.56707665884E-02 4.64424235581E-02 4.72270371931E-02 4.80248039342E-02 4.88359557198E-02 4.96607149643E-02 5.04993025760E-02 5.13519634998E-02 5.22189034645E-02 5.31004075309E-02 5.39966677216E-02 5.49079689216E-02 5.58345436871E-02 5.67766503663E-02 5.77345451763E-02 5.87085049608E-02 5.96987672609E-02 6.07056423807E-02 6.17293788803E-02 6.27702681011E-02 6.38285941951E-02 6.49046451344E-02 6.59987184469E-02 6.71111134037E-02 6.82421351954E-02 6.93920877362E-02 7.05612961449E-02 7.17500661374E-02 7.29587375650E-02 7.41876290339E-02 7.54370779330E-02 7.67074264815E-02 7.79990308996E-02 7.93122170648E-02 8.06473710223E-02 8.20048377120E-02 8.33849918083E-02 8.47882111548E-02 8.62148667466E-02 8.76653540662E-02 8.91400718969E-02 9.06393978603E-02 9.21637609915E-02 9.37135542498E-02 9.52892139508E-02 9.68911502038E-02 9.85197992337E-02 1.00175597922E-01 1.01858999774E-01 1.03570445097E-01 1.05310399865E-01 1.07079326641E-01 1.08877700335E-01 1.10706002803E-01 1.12564716937E-01 1.14454343316E-01 1.16375382410E-01 1.18328340750E-01 1.20313744856E-01 1.22332111697E-01 1.24383978943E-01 1.26469888532E-01 1.28590387865E-01 1.30746034954E-01 1.32937398529E-01 1.35165044447E-01 1.37429564356E-01 1.39731544186E-01 1.42071580913E-01 1.44450287553E-01 1.46868271838E-01 1.49326169219E-01 1.51824602570E-01 1.54364220466E-01 1.56945671555E-01 1.59569615866E-01 1.62236720665E-01 1.64947666777E-01 1.67703135002E-01 1.70503825270E-01 1.73350440861E-01 1.76243695272E-01 1.79184306941E-01 1.82173015853E-01 1.85210549692E-01 1.88297671246E-01 1.91435128430E-01 1.94623692773E-01 1.97864139464E-01 2.01157255543E-01 2.04503827830E-01 2.07904666373E-01 2.11360578677E-01 2.14872383119E-01 2.18440906108E-01 2.22066988353E-01 2.25751468730E-01 2.29495201284E-01 2.33299045225E-01 2.37163867340E-01 2.41090541159E-01 2.45079950476E-01 2.49132979515E-01 2.53250526809E-01 2.57433489062E-01 2.61682776931E-01 2.65999298127E-01 2.70383973490E-01 2.74837721814E-01 2.79361471089E-01 2.83956146626E-01 2.88622686719E-01 2.93362022424E-01 2.98175091008E-01 3.03062831540E-01 3.08026182712E-01 3.13066081324E-01 3.18183467272E-01 3.23379275217E-01 3.28654436054E-01 3.34009881687E-01 3.39446535305E-01 3.44965313043E-01 3.50567131125E-01 3.56252886944E-01 3.62023478951E-01 3.67879785176E-01 3.73822678661E-01 3.79853014722E-01 3.85971632803E-01 3.92179355947E-01 3.98476988300E-01 4.04865312827E-01 4.11345086671E-01 4.17917044909E-01 4.24581894690E-01 4.31340308176E-01 4.38192932053E-01 4.45140371130E-01 4.52183197536E-01 4.59321936187E-01 4.66557072725E-01 4.73889042388E-01 4.81318229911E-01 4.88844964658E-01 4.96469517812E-01 5.04192096347E-01 5.12012843338E-01 5.19931825219E-01 5.27949036612E-01 5.36064388656E-01 5.44277705898E-01 5.52588721864E-01 5.60997070956E-01 5.69502286909E-01 5.78103788284E-01 5.86800882605E-01 5.95592749956E-01 6.04478442190E-01 6.13456871305E-01 6.22526803769E-01 6.31686851100E-01 6.40935463565E-01 6.50270915552E-01 6.59691305277E-01 6.69194533195E-01 6.78778304039E-01 6.88440106591E-01 6.98177205931E-01 7.07986635081E-01 7.17865176084E-01 7.27809353320E-01 7.37815417925E-01 7.47879332803E-01 7.57996763041E-01 7.68163054790E-01 7.78373226386E-01 7.88621947773E-01 7.98903527238E-01 8.09211892068E-01 8.19540573605E-01 8.29882686121E-01 8.40230911404E-01 8.50577477184E-01 8.60914137243E-01 8.71232153269E-01 8.81522271502E-01 8.91774701603E-01 9.01979096902E-01 9.12124527691E-01 9.22199461979E-01 9.32191740776E-01 9.42088551622E-01 9.51876410853E-01 9.61541129285E-01 9.71067796069E-01 9.80440749376E-01 9.89643552362E-01 9.98658964986E-01 1.00746892548E+00 1.01605451488E+00 1.02439594421E+00 1.03247251983E+00 1.04026262486E+00 1.04774369587E+00 1.05489219659E+00 1.06168360378E+00 1.06809237883E+00 1.07409195648E+00 1.07965472468E+00 1.08475201025E+00 1.08935406894E+00 1.09343007245E+00 1.09694810814E+00 1.09987516810E+00 1.10217715871E+00 1.10381890100E+00 1.10476414239E+00 1.10497557439E+00 1.10441485263E+00 1.10304262569E+00 1.10081857278E+00 1.09770144586E+00 1.09364912265E+00 1.08861866898E+00 1.08256641306E+00 1.07544802532E+00 1.06721861813E+00 1.05783285277E+00 1.04724506444E+00 1.03540939723E+00 1.02227996434E+00 1.00781101349E+00 9.91957124474E-01 9.74673414951E-01 9.55915773258E-01 9.35641114403E-01 9.13807654123E-01 8.90375214581E-01 8.65305549537E-01 8.38562701830E-01 8.10113387398E-01 7.79927408093E-01 7.47978094914E-01 7.14242788159E-01 6.78703340036E-01 6.41346661813E-01 6.02165296839E-01 5.61158031178E-01 5.18330539209E-01 4.73696064215E-01 4.27276128942E-01 3.79101288991E-01 3.29211909183E-01 2.77658979540E-01 2.24504958060E-01 1.69824639949E-01 1.13706057581E-01 5.62513969122E-02 -2.42206535501E-03 -6.21810089089E-02 -1.22875115388E-01 -1.84336103810E-01 -2.46376782312E-01 -3.08790107156E-01 -3.71348276671E-01 -4.33801860127E-01 -4.95878987260E-01 -5.57284615183E-01 -6.17699892188E-01 -6.76781659664E-01 -7.34162111062E-01 -7.89448676485E-01 -8.42224160061E-01 -8.92047228966E-01 -9.38453315976E-01 -9.80956056210E-01 -1.01904938396E+00 -1.05221045248E+00 -1.07990357295E+00 -1.10158541445E+00 -1.11671175527E+00 -1.12474612430E+00 -1.12517074630E+00 -1.11750025220E+00 -1.10129869108E+00 -1.07620042178E+00 -1.04193550856E+00 -9.98360219809E-01 -9.45493180808E-01 -8.83557529216E-01 -8.13029115457E-01 -7.34690174203E-01 -6.49686999053E-01 -5.59588661542E-01 -4.66441658436E-01 -3.72812111694E-01 -2.81802451090E-01 -1.97022696292E-01 -1.22487423614E-01 -6.23901479389E-02 -2.07445053753E-02 -3.08498171776E-04 -5.79226432817E-04 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 3 1 Beta L 627 0.00000000000E+00 -4.25233577176E-12 3.04783600944E-09 2.71960604691E-09 2.71204279433E-09 2.65969537725E-09 2.59834368262E-09 2.52344243684E-09 2.43499497755E-09 2.33189055512E-09 2.21381944596E-09 2.08056938886E-09 1.92995039188E-09 1.76285126602E-09 1.57735007132E-09 1.37265861150E-09 1.14918472484E-09 9.04574743890E-10 6.38015767511E-10 3.50785147213E-10 3.73659554345E-11 -2.98573935230E-10 -6.60530184304E-10 -1.04720055492E-09 -1.46653815668E-09 -1.90980388989E-09 -2.38590712728E-09 -2.89236454365E-09 -3.43082696677E-09 -4.00808180112E-09 -4.61304652613E-09 -5.26273761997E-09 -5.94576045774E-09 -6.67149871474E-09 -7.43910463005E-09 -8.24924780527E-09 -9.10491954184E-09 -1.00069126851E-08 -1.09606325678E-08 -1.19616759401E-08 -1.30196552255E-08 -1.41301045235E-08 -1.52960193490E-08 -1.65279438973E-08 -1.78162995043E-08 -1.91713433516E-08 -2.05902681892E-08 -2.20863889208E-08 -2.36471916925E-08 -2.52835397537E-08 -2.70015786386E-08 -2.88041380572E-08 -3.06784698994E-08 -3.26533648072E-08 -3.47097465674E-08 -3.68661633872E-08 -3.91162708735E-08 -4.14762733828E-08 -4.39260630132E-08 -4.65029761011E-08 -4.91828538458E-08 -5.19856163648E-08 -5.49024902795E-08 -5.79602516206E-08 -6.11365872543E-08 -6.44591264251E-08 -6.79131462910E-08 -7.15265939715E-08 -7.52860423971E-08 -7.92045017369E-08 -8.32851334817E-08 -8.75430329563E-08 -9.19669100413E-08 -9.65853940944E-08 -1.01384471160E-07 -1.06378578944E-07 -1.11600718517E-07 -1.16998068473E-07 -1.22642328620E-07 -1.28503061246E-07 -1.34603031756E-07 -1.40944311312E-07 -1.47537691601E-07 -1.54404526972E-07 -1.61525952509E-07 -1.68945367127E-07 -1.76648777545E-07 -1.84655814533E-07 -1.92979655291E-07 -2.01627562015E-07 -2.10611320170E-07 -2.19945432025E-07 -2.29632330192E-07 -2.39708821866E-07 -2.50174385339E-07 -2.61022102984E-07 -2.72295046231E-07 -2.84020528352E-07 -2.96162286110E-07 -3.08779038635E-07 -3.21884581654E-07 -3.35470813996E-07 -3.49580016313E-07 -3.64226358793E-07 -3.79413235318E-07 -3.95179671766E-07 -4.11531812124E-07 -4.28503345952E-07 -4.46102690268E-07 -4.64363357363E-07 -4.83291480064E-07 -5.02955471801E-07 -5.23309552105E-07 -5.44437143215E-07 -5.66364499469E-07 -5.89054628417E-07 -6.12628644232E-07 -6.37044017467E-07 -6.62363727506E-07 -6.88618230069E-07 -7.15819791450E-07 -7.44033552396E-07 -7.73267240940E-07 -8.03572712922E-07 -8.34984172355E-07 -8.67539921089E-07 -9.01269680469E-07 -9.36227784134E-07 -9.72460309970E-07 -1.00999396497E-06 -1.04890058641E-06 -1.08919859361E-06 -1.13095395412E-06 -1.17421290528E-06 -1.21904046822E-06 -1.26546932831E-06 -1.31356706456E-06 -1.36339236776E-06 -1.41500784221E-06 -1.46847060211E-06 -1.52383990176E-06 -1.58120185853E-06 -1.64059475172E-06 -1.70211549103E-06 -1.76583924362E-06 -1.83180556973E-06 -1.90015425152E-06 -1.97091551134E-06 -2.04417732352E-06 -2.12005997333E-06 -2.19862377186E-06 -2.27998377329E-06 -2.36420916556E-06 -2.45141140398E-06 -2.54172445583E-06 -2.63519178989E-06 -2.73198499843E-06 -2.83218865418E-06 -2.93590839683E-06 -3.04331205070E-06 -3.15446774662E-06 -3.26955086560E-06 -3.38867236672E-06 -3.51198451006E-06 -3.63962030825E-06 -3.77175040706E-06 -3.90849430018E-06 -4.05004875517E-06 -4.19654175028E-06 -4.34819338079E-06 -4.50511946911E-06 -4.66755943699E-06 -4.83566125208E-06 -5.00963399197E-06 -5.18970390289E-06 -5.37602261326E-06 -5.56889432675E-06 -5.76840568876E-06 -5.97497141184E-06 -6.18863374915E-06 -6.40981552996E-06 -6.63864574486E-06 -6.87545016394E-06 -7.12048244336E-06 -7.37404762243E-06 -7.63640214174E-06 -7.90785026972E-06 -8.18877426702E-06 -8.47938790762E-06 -8.78011255157E-06 -9.09125737052E-06 -9.41316763895E-06 -9.74625966184E-06 -1.00908566105E-05 -1.04473829559E-05 -1.08162869674E-05 -1.11978814842E-05 -1.15927361311E-05 -1.20012019380E-05 -1.24238111468E-05 -1.28609706723E-05 -1.33132863291E-05 -1.37811682682E-05 -1.42652201612E-05 -1.47659698082E-05 -1.52839926745E-05 -1.58198543922E-05 -1.63742335362E-05 -1.69476721362E-05 -1.75408652083E-05 -1.81545406332E-05 -1.87892753829E-05 -1.94459139654E-05 -2.01251231608E-05 -2.08277141150E-05 -2.15544456675E-05 -2.23061964514E-05 -2.30837697252E-05 -2.38880943360E-05 -2.47200338073E-05 -2.55805508317E-05 -2.64706492370E-05 -2.73913053881E-05 -2.83435448508E-05 -2.93284858795E-05 -3.03472432181E-05 -3.14009119119E-05 -3.24907730827E-05 -3.36179757789E-05 -3.47838429873E-05 -3.59896768391E-05 -3.72368365173E-05 -3.85267377692E-05 -3.98608395241E-05 -4.12406486336E-05 -4.26676873521E-05 -4.41436235148E-05 -4.56700773951E-05 -4.72487888435E-05 -4.88815441049E-05 -5.05701537881E-05 -5.23165656209E-05 -5.41227049359E-05 -5.59906024882E-05 -5.79224349627E-05 -5.99202838007E-05 -6.19864380788E-05 -6.41232376354E-05 -6.63330718559E-05 -6.86184057369E-05 -7.09818459894E-05 -7.34260299162E-05 -7.59536888993E-05 -7.85677238319E-05 -8.12709830390E-05 -8.40665857919E-05 -8.69576177422E-05 -8.99473500687E-05 -9.30391338203E-05 -9.62364341199E-05 -9.95428621684E-05 -1.02962088242E-04 -1.06497992744E-04 -1.10154514991E-04 -1.13935749121E-04 -1.17845951201E-04 -1.21889536401E-04 -1.26070940657E-04 -1.30394986610E-04 -1.34866398729E-04 -1.39490245037E-04 -1.44271703255E-04 -1.49216118049E-04 -1.54329036922E-04 -1.59616189274E-04 -1.65083451154E-04 -1.70737031351E-04 -1.76583152660E-04 -1.82628456434E-04 -1.88879618573E-04 -1.95343713830E-04 -2.02027917838E-04 -2.08939722028E-04 -2.16086878288E-04 -2.23477344507E-04 -2.31119427389E-04 -2.39021614282E-04 -2.47192787876E-04 -2.55642066587E-04 -2.64378884398E-04 -2.73412998985E-04 -2.82754553417E-04 -2.92413885192E-04 -3.02401927525E-04 -3.12729677161E-04 -3.23408780747E-04 -3.34451131091E-04 -3.45869055643E-04 -3.57675280402E-04 -3.69883015581E-04 -3.82505887747E-04 -3.95557971395E-04 -4.09053794445E-04 -4.23008509029E-04 -4.37437596990E-04 -4.52357183614E-04 -4.67783944543E-04 -4.83735001720E-04 -5.00228244728E-04 -5.17281984887E-04 -5.34915280874E-04 -5.53147771686E-04 -5.71999772120E-04 -5.91492337467E-04 -6.11647122515E-04 -6.32486661520E-04 -6.54034093339E-04 -6.76313514395E-04 -6.99349647484E-04 -7.23168239013E-04 -7.47795749633E-04 -7.73259636123E-04 -7.99588245225E-04 -8.26810898784E-04 -8.54957870303E-04 -8.84060507121E-04 -9.14151252476E-04 -9.45263467146E-04 -9.77431886650E-04 -1.01069226359E-03 -1.04508157363E-03 -1.08063804516E-03 -1.11740134107E-03 -1.15541217951E-03 -1.19471297106E-03 -1.23534728458E-03 -1.27736036475E-03 -1.32079889665E-03 -1.36571111709E-03 -1.41214695177E-03 -1.46015799716E-03 -1.50979756393E-03 -1.56112077728E-03 -1.61418469741E-03 -1.66904812265E-03 -1.72577208561E-03 -1.78441941874E-03 -1.84505534557E-03 -1.90774703730E-03 -1.97256408008E-03 -2.03957839901E-03 -2.10886428048E-03 -2.18049853494E-03 -2.25456065550E-03 -2.33113262498E-03 -2.41029940725E-03 -2.49214861552E-03 -2.57677101704E-03 -2.66426025060E-03 -2.75471326680E-03 -2.84823011576E-03 -2.94491439417E-03 -3.04487300333E-03 -3.14821662376E-03 -3.25505942447E-03 -3.36551966981E-03 -3.47971940828E-03 -3.59778484298E-03 -3.71984646312E-03 -3.84603903507E-03 -3.97650194948E-03 -4.11137920361E-03 -4.25081969216E-03 -4.39497714629E-03 -4.54401066418E-03 -4.69808448394E-03 -4.85736846254E-03 -5.02203802016E-03 -5.19227462842E-03 -5.36826556035E-03 -5.55020459382E-03 -5.73829186784E-03 -5.93273413243E-03 -6.13374519088E-03 -6.34154581118E-03 -6.55636423091E-03 -6.77843626423E-03 -7.00800547927E-03 -7.24532369291E-03 -7.49065092152E-03 -7.74425598648E-03 -8.00641650626E-03 -8.27741931241E-03 -8.55756078727E-03 -8.84714711410E-03 -9.14649457355E-03 -9.45592989009E-03 -9.77579062722E-03 -1.01064254538E-02 -1.04481944935E-02 -1.08014697569E-02 -1.11666355294E-02 -1.15440886341E-02 -1.19342390110E-02 -1.23375098779E-02 -1.27543385225E-02 -1.31851764259E-02 -1.36304896796E-02 -1.40907598589E-02 -1.45664839717E-02 -1.50581753320E-02 -1.55663638527E-02 -1.60915966696E-02 -1.66344386277E-02 -1.71954728005E-02 -1.77753011015E-02 -1.83745448000E-02 -1.89938452631E-02 -1.96338641851E-02 -2.02952847669E-02 -2.09788117827E-02 -2.16851726553E-02 -2.24151178499E-02 -2.31694218163E-02 -2.39488832739E-02 -2.47543265005E-02 -2.55866015049E-02 -2.64465851543E-02 -2.73351817551E-02 -2.82533239524E-02 -2.92019733074E-02 -3.01821214953E-02 -3.11947907007E-02 -3.22410348032E-02 -3.33219399818E-02 -3.44386259072E-02 -3.55922462142E-02 -3.67839898315E-02 -3.80150816360E-02 -3.92867833860E-02 -4.06003949356E-02 -4.19572548124E-02 -4.33587415072E-02 -4.48062742619E-02 -4.63013142446E-02 -4.78453652355E-02 -4.94399750572E-02 -5.10867361739E-02 -5.27872870865E-02 -5.45433129240E-02 -5.63565468948E-02 -5.82287710618E-02 -6.01618172581E-02 -6.21575684005E-02 -6.42179592139E-02 -6.63449773097E-02 -6.85406641319E-02 -7.08071159849E-02 -7.31464847988E-02 -7.55609791284E-02 -7.80528650687E-02 -8.06244668780E-02 -8.32781680208E-02 -8.60164116932E-02 -8.88417016242E-02 -9.17566026311E-02 -9.47637412625E-02 -9.78658062525E-02 -1.01065548777E-01 -1.04365783149E-01 -1.07769386497E-01 -1.11279299501E-01 -1.14898525801E-01 -1.18630132344E-01 -1.22477248801E-01 -1.26443067320E-01 -1.30530841945E-01 -1.34743887827E-01 -1.39085580274E-01 -1.43559353716E-01 -1.48168700257E-01 -1.52917168268E-01 -1.57808360261E-01 -1.62845931098E-01 -1.68033585704E-01 -1.73375075746E-01 -1.78874197718E-01 -1.84534788470E-01 -1.90360722596E-01 -1.96355907343E-01 -2.02524279086E-01 -2.08869797794E-01 -2.15396441885E-01 -2.22108202557E-01 -2.29009077220E-01 -2.36103062795E-01 -2.43394148383E-01 -2.50886307252E-01 -2.58583487995E-01 -2.66489606011E-01 -2.74608532870E-01 -2.82944086365E-01 -2.91500018977E-01 -3.00280006067E-01 -3.09287632959E-01 -3.18526381682E-01 -3.27999616347E-01 -3.37710568225E-01 -3.47662319614E-01 -3.57857787004E-01 -3.68299703059E-01 -3.78990598434E-01 -3.89932781301E-01 -4.01128317647E-01 -4.12579009009E-01 -4.24286370264E-01 -4.36251606007E-01 -4.48475586053E-01 -4.60958819908E-01 -4.73701430029E-01 -4.86703124714E-01 -4.99963169035E-01 -5.13480355595E-01 -5.27252973781E-01 -5.41278778211E-01 -5.55554955945E-01 -5.70078093120E-01 -5.84844139700E-01 -5.99848374240E-01 -6.15085366604E-01 -6.30548940052E-01 -6.46232132067E-01 -6.62127153844E-01 -6.78225348591E-01 -6.94517147965E-01 -7.10992027929E-01 -7.27638461287E-01 -7.44443870022E-01 -7.61394574072E-01 -7.78475738471E-01 -7.95671317234E-01 -8.12963994452E-01 -8.30335121381E-01 -8.47764649759E-01 -8.65231060472E-01 -8.82711286422E-01 -9.00180630636E-01 -9.17612676179E-01 -9.34979190456E-01 -9.52250019849E-01 -9.69392976587E-01 -9.86373715543E-01 -1.00315560093E+00 -1.01969956209E+00 -1.03596393892E+00 -1.05190431497E+00 -1.06747334121E+00 -1.08262054857E+00 -1.09729215273E+00 -1.11143085241E+00 -1.12497562405E+00 -1.13786151893E+00 -1.15001946587E+00 -1.16137609038E+00 -1.17185355668E+00 -1.18136944725E+00 -1.18983669235E+00 -1.19716356945E+00 -1.20325379108E+00 -1.20800670841E+00 -1.21131765708E+00 -1.21307847863E+00 -1.21317825433E+00 -1.21150429005E+00 -1.20794339646E+00 -1.20238350793E+00 -1.19471568590E+00 -1.18483654856E+00 -1.17265116428E+00 -1.15807643576E+00 -1.14104498643E+00 -1.12150953722E+00 -1.09944773059E+00 -1.07486731434E+00 -1.04781154252E+00 -1.01836457801E+00 -9.86656592832E-01 -9.52868155009E-01 -9.17233363960E-01 -8.80041054114E-01 -8.41633230414E-01 -8.02399741515E-01 -7.62768052368E-01 -7.23186872072E-01 -6.84102370404E-01 -6.45925834292E-01 -6.08991966676E-01 -5.73507743118E-01 -5.39493001370E-01 -5.06716003905E-01 -4.74630444928E-01 -4.42325267590E-01 -4.08505897765E-01 -3.71536017152E-01 -3.29584054188E-01 -2.80939840059E-01 -2.24596970270E-01 -1.61235317761E-01 -9.48198330095E-02 -3.48735002448E-02 -1.87440750384E-03 2.51475959421E-04 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 4 1 Beta L 627 0.00000000000E+00 -1.65658701348E-12 -1.49959068716E-08 -1.34696294890E-08 -1.35504214770E-08 -1.34458108774E-08 -1.33401197869E-08 -1.32058205460E-08 -1.30501359171E-08 -1.28654064059E-08 -1.26556288841E-08 -1.24226194022E-08 -1.21501369865E-08 -1.18598585959E-08 -1.15234976065E-08 -1.11650481638E-08 -1.07654704821E-08 -1.03365902987E-08 -9.85316783957E-09 -9.36125414617E-09 -8.78297115604E-09 -8.19680504417E-09 -7.55008174991E-09 -6.89298645894E-09 -6.09867228605E-09 -5.34503413133E-09 -4.48556019736E-09 -3.59242557008E-09 -2.65792275957E-09 -1.57889797450E-09 -5.63812814151E-10 6.28165593518E-10 1.81589695380E-09 3.12286559813E-09 4.47708985467E-09 5.92529745894E-09 7.43078897627E-09 9.03222723162E-09 1.07358635821E-08 1.25041907111E-08 1.43965528157E-08 1.63631545397E-08 1.83970344086E-08 2.06353243276E-08 2.28988820526E-08 2.53177161141E-08 2.77797911661E-08 3.05241045650E-08 3.32615219614E-08 3.61198094574E-08 3.92080688804E-08 4.24583082720E-08 4.56958272144E-08 4.92587579892E-08 5.28847211695E-08 5.67247407565E-08 6.06927692049E-08 6.49618706503E-08 6.91859173930E-08 7.38549905810E-08 7.85988492999E-08 8.35895715259E-08 8.86697628854E-08 9.42303890774E-08 9.97923805533E-08 1.05726919481E-07 1.11773954079E-07 1.18291805664E-07 1.24947365422E-07 1.31865323601E-07 1.39127356723E-07 1.46729716572E-07 1.54513155607E-07 1.62763503222E-07 1.71256582994E-07 1.80019306652E-07 1.89595861247E-07 1.98822858814E-07 2.09075635284E-07 2.19404804833E-07 2.30242374239E-07 2.41507775521E-07 2.53151387148E-07 2.65477494544E-07 2.77954237617E-07 2.91234771007E-07 3.04900210887E-07 3.19062245791E-07 3.33874683410E-07 3.49261440763E-07 3.65191342765E-07 3.81783786993E-07 3.98826058955E-07 4.16877240502E-07 4.35540726310E-07 4.54618058635E-07 4.74557965349E-07 4.95695386977E-07 5.17015908928E-07 5.39390740756E-07 5.62810282104E-07 5.86816844143E-07 6.11872136432E-07 6.37951790077E-07 6.64828277176E-07 6.92910545960E-07 7.21843298611E-07 7.52033442304E-07 7.83275233461E-07 8.15713888293E-07 8.49147943765E-07 8.84362864820E-07 9.20260649017E-07 9.57769699062E-07 9.96985274342E-07 1.03684002123E-06 1.07901713187E-06 1.12225373968E-06 1.16715522107E-06 1.21391523188E-06 1.26204621699E-06 1.31221874220E-06 1.36407696712E-06 1.41789920966E-06 1.47364892396E-06 1.53156843577E-06 1.59135608216E-06 1.65335689343E-06 1.71778553971E-06 1.78431992137E-06 1.85351240911E-06 1.92498308259E-06 1.99915401056E-06 2.07585664375E-06 2.15556669737E-06 2.23795673276E-06 2.32332126057E-06 2.41175456360E-06 2.50345729870E-06 2.59833784677E-06 2.69664274008E-06 2.79858047102E-06 2.90390032547E-06 3.01309179935E-06 3.12638510047E-06 3.24323148897E-06 3.36479823549E-06 3.49050287954E-06 3.62034468159E-06 3.75514812351E-06 3.89459881548E-06 4.03922088545E-06 4.18861422133E-06 4.34332907670E-06 4.50387857498E-06 4.66962618341E-06 4.84154906800E-06 5.01952769846E-06 5.20345060606E-06 5.39442123191E-06 5.59157788592E-06 5.79591734299E-06 6.00743569104E-06 6.22634363596E-06 6.45288974292E-06 6.68762657402E-06 6.93023345153E-06 7.18168010887E-06 7.44157903713E-06 7.71099503875E-06 7.98952880250E-06 8.27793193478E-06 8.57635884213E-06 8.88513793756E-06 9.20502498229E-06 9.53558416855E-06 9.87837076576E-06 1.02319897767E-05 1.05994069443E-05 1.09780676318E-05 1.13712506584E-05 1.17772939922E-05 1.21977301541E-05 1.26327208626E-05 1.30830273783E-05 1.35487987287E-05 1.40303581374E-05 1.45296393323E-05 1.50451845509E-05 1.55792295619E-05 1.61316943330E-05 1.67029813700E-05 1.72946650264E-05 1.79062617794E-05 1.85390642577E-05 1.91944914819E-05 1.98713528439E-05 2.05727670110E-05 2.12977898546E-05 2.20482981145E-05 2.28240278978E-05 2.36274707842E-05 2.44578338843E-05 2.53172795284E-05 2.62063258825E-05 2.71260726847E-05 2.80771661510E-05 2.90617450191E-05 3.00796975351E-05 3.11324885811E-05 3.22225552692E-05 3.33489672338E-05 3.45149786490E-05 3.57207968291E-05 3.69681799234E-05 3.82582538528E-05 3.95929951645E-05 4.09733094840E-05 4.24015408853E-05 4.38784247955E-05 4.54059384937E-05 4.69864357377E-05 4.86209880842E-05 5.03113769578E-05 5.20599698932E-05 5.38688750041E-05 5.57391111281E-05 5.76744072083E-05 5.96754079821E-05 6.17452007371E-05 6.38861275093E-05 6.61001182604E-05 6.83901870814E-05 7.07587211197E-05 7.32085202536E-05 7.57417817233E-05 7.83622022164E-05 8.10720778581E-05 8.38749156085E-05 8.67736960329E-05 8.97714150352E-05 9.28720815891E-05 9.60786106191E-05 9.93943478716E-05 1.02824574333E-04 1.06371189639E-04 1.10039249372E-04 1.13832875815E-04 1.17756132090E-04 1.21813306934E-04 1.26009220718E-04 1.30348518972E-04 1.34835701040E-04 1.39476895295E-04 1.44275752753E-04 1.49239056005E-04 1.54371513812E-04 1.59679270991E-04 1.65168213017E-04 1.70844342057E-04 1.76714521672E-04 1.82784502879E-04 1.89062085663E-04 1.95553475526E-04 2.02266362105E-04 2.09208010776E-04 2.16387037668E-04 2.23809750811E-04 2.31486805490E-04 2.39424726299E-04 2.47633353314E-04 2.56121935036E-04 2.64899671422E-04 2.73976641919E-04 2.83363055227E-04 2.93068607638E-04 3.03105816180E-04 3.13483936183E-04 3.24216262224E-04 3.35313626392E-04 3.46789320078E-04 3.58655527670E-04 3.70925678088E-04 3.83613936113E-04 3.96733690093E-04 4.10300669312E-04 4.24328724345E-04 4.38834631983E-04 4.53834217504E-04 4.69344081935E-04 4.85381591603E-04 5.01965312344E-04 5.19112221926E-04 5.36843794989E-04 5.55177361683E-04 5.74134949030E-04 5.93737411372E-04 6.14006564782E-04 6.34964635927E-04 6.56635495509E-04 6.79043534261E-04 7.02213278982E-04 7.26170058445E-04 7.50942214403E-04 7.76555910511E-04 8.03040045073E-04 8.30424965306E-04 8.58739574578E-04 8.88017177054E-04 9.18289315624E-04 9.49590170777E-04 9.81954390107E-04 1.01541793835E-03 1.05001885687E-03 1.08579441949E-03 1.12278582442E-03 1.16103289050E-03 1.20057972126E-03 1.24146874323E-03 1.28374696798E-03 1.32746029387E-03 1.37265796736E-03 1.41939017959E-03 1.46770883708E-03 1.51766782588E-03 1.56932211062E-03 1.62273078208E-03 1.67795069224E-03 1.73504543931E-03 1.79407784197E-03 1.85511298395E-03 1.91821847715E-03 1.98346638888E-03 2.05092641272E-03 2.12067611303E-03 2.19279073409E-03 2.26735171732E-03 2.34444176299E-03 2.42414558630E-03 2.50655253687E-03 2.59175363484E-03 2.67984334387E-03 2.77091931796E-03 2.86508351610E-03 2.96243851158E-03 3.06309417641E-03 3.16716009893E-03 3.27475375582E-03 3.38599258089E-03 3.50100025093E-03 3.61990477453E-03 3.74283710705E-03 3.86993291502E-03 4.00133430699E-03 4.13718490755E-03 4.27763653451E-03 4.42284265648E-03 4.57296586780E-03 4.72817013605E-03 4.88862861893E-03 5.05451669136E-03 5.22601933675E-03 5.40332416299E-03 5.58662871136E-03 5.77613265327E-03 5.97204720973E-03 6.17458725246E-03 6.38397573869E-03 6.60044401422E-03 6.82422965746E-03 7.05557921971E-03 7.29474719757E-03 7.54199719856E-03 7.79759918859E-03 8.06183594190E-03 8.33499627073E-03 8.61738087832E-03 8.90929818684E-03 9.21107051297E-03 9.52302575069E-03 9.84550739357E-03 1.01788684965E-02 1.05234722688E-02 1.08796970759E-02 1.12479309105E-02 1.16285763088E-02 1.20220491693E-02 1.24287771525E-02 1.28492050501E-02 1.32837887632E-02 1.37330029042E-02 1.41973350734E-02 1.46772891741E-02 1.51733865568E-02 1.56861653612E-02 1.62161809350E-02 1.67640065435E-02 1.73302351493E-02 1.79154784712E-02 1.85203673983E-02 1.91455544278E-02 1.97917129904E-02 2.04595376177E-02 2.11497466276E-02 2.18630786850E-02 2.26003002691E-02 2.33622003086E-02 2.41495909202E-02 2.49633151971E-02 2.58042386421E-02 2.66732568580E-02 2.75712927985E-02 2.84992992831E-02 2.94582592263E-02 3.04491860049E-02 3.14731259770E-02 3.25311564005E-02 3.36243920434E-02 3.47539768248E-02 3.59210963357E-02 3.71269679933E-02 3.83728501127E-02 3.96600375933E-02 4.09898679144E-02 4.23637146632E-02 4.37829991358E-02 4.52491808539E-02 4.67637661796E-02 4.83283055375E-02 4.99443970106E-02 5.16136838085E-02 5.33378610587E-02 5.51186711122E-02 5.69579090706E-02 5.88574204470E-02 6.08191073126E-02 6.28449224533E-02 6.49368777078E-02 6.70970407909E-02 6.93275360178E-02 7.16305503712E-02 7.40083281190E-02 7.64631770694E-02 7.89974666466E-02 8.16136319169E-02 8.43141698804E-02 8.71016461861E-02 8.99786911570E-02 9.29480056018E-02 9.60123548975E-02 9.91745773401E-02 1.02437580763E-01 1.05804341072E-01 1.09277908714E-01 1.12861404145E-01 1.16558019792E-01 1.20371020194E-01 1.24303743084E-01 1.28359596934E-01 1.32542061999E-01 1.36854691968E-01 1.41301107281E-01 1.45885001945E-01 1.50610135879E-01 1.55480337276E-01 1.60499498801E-01 1.65671577243E-01 1.71000590818E-01 1.76490613151E-01 1.82145777639E-01 1.87970263286E-01 1.93968302569E-01 2.00144165617E-01 2.06502164123E-01 2.13046639392E-01 2.19781959730E-01 2.26712512072E-01 2.33842694666E-01 2.41176907621E-01 2.48719545139E-01 2.56474984112E-01 2.64447574523E-01 2.72641624411E-01 2.81061389074E-01 2.89711058740E-01 2.98594734291E-01 3.07716423199E-01 3.17080008310E-01 3.26689239269E-01 3.36547700610E-01 3.46658797728E-01 3.57025728296E-01 3.67651451489E-01 3.78538669506E-01 3.89689784513E-01 4.01106876063E-01 4.12791658697E-01 4.24745450911E-01 4.36969124009E-01 4.49463073167E-01 4.62227159842E-01 4.75260667501E-01 4.88562251634E-01 5.02129879690E-01 5.15960776894E-01 5.30051361298E-01 5.44397179968E-01 5.58992836742E-01 5.73831924161E-01 5.88906939349E-01 6.04209207315E-01 6.19728796243E-01 6.35454420853E-01 6.51373359235E-01 6.67471343315E-01 6.83732465671E-01 7.00139064730E-01 7.16671622269E-01 7.33308640239E-01 7.50026526705E-01 7.66799473306E-01 7.83599327841E-01 8.00395464759E-01 8.17154657806E-01 8.33840941296E-01 8.50415479863E-01 8.66836432137E-01 8.83058812825E-01 8.99034365166E-01 9.14711423837E-01 9.30034793188E-01 9.44945620635E-01 9.59381288679E-01 9.73275304841E-01 9.86557209477E-01 9.99152501915E-01 1.01098256929E+00 1.02196465226E+00 1.03201182389E+00 1.04103299671E+00 1.04893296659E+00 1.05561248584E+00 1.06096838379E+00 1.06489372738E+00 1.06727804122E+00 1.06800757561E+00 1.06696565354E+00 1.06403307112E+00 1.05908859519E+00 1.05200953319E+00 1.04267240054E+00 1.03095369590E+00 1.01673077213E+00 9.99882833952E-01 9.80292057241E-01 9.57844830185E-01 9.32433139398E-01 9.03956088014E-01 8.72321558552E-01 8.37448018844E-01 7.99266463938E-01 7.57722504945E-01 7.12778569545E-01 6.64416235497E-01 6.12638646453E-01 5.57473013704E-01 4.98973153249E-01 4.37222041843E-01 3.72334324092E-01 3.04458738358E-01 2.33780390228E-01 1.60522788838E-01 8.49495993340E-02 7.36597429706E-03 -7.18805923803E-02 -1.52400020381E-01 -2.33760110191E-01 -3.15487825018E-01 -3.97071511152E-01 -4.77964133157E-01 -5.57587619562E-01 -6.35338359129E-01 -7.10593863273E-01 -7.82720547051E-01 -8.51082521261E-01 -9.15051181127E-01 -9.74015304918E-01 -1.02739120019E+00 -1.07463235278E+00 -1.11523783143E+00 -1.14875858222E+00 -1.17480060841E+00 -1.19302391380E+00 -1.20313612502E+00 -1.20487978194E+00 -1.19801266769E+00 -1.18228117929E+00 -1.15738790346E+00 -1.12295632902E+00 -1.07849838907E+00 -1.02339450098E+00 -9.56901532526E-01 -8.78212129962E-01 -7.86599931143E-01 -6.81700225853E-01 -5.63995767033E-01 -4.35604457726E-01 -3.01497953927E-01 -1.71351981547E-01 -6.20344298111E-02 -3.25516210753E-03 -7.09335840508E-04 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 5 2 Beta L 627 0.00000000000E+00 -1.48015699683E-17 -3.14800094846E-12 -2.89900468192E-12 -2.98569713916E-12 -3.04032045731E-12 -3.09911013246E-12 -3.15849544550E-12 -3.21884739419E-12 -3.28007715590E-12 -3.34227528274E-12 -3.40538773352E-12 -3.46935509149E-12 -3.53435782885E-12 -3.60010677170E-12 -3.66682487911E-12 -3.73457193246E-12 -3.80292516630E-12 -3.87233182367E-12 -3.94252703454E-12 -4.01370097077E-12 -4.08517110185E-12 -4.15835333781E-12 -4.23128235865E-12 -4.30557984188E-12 -4.38044448042E-12 -4.45584188654E-12 -4.53214382528E-12 -4.60827752947E-12 -4.68656746576E-12 -4.76324070934E-12 -4.84211477424E-12 -4.92002988552E-12 -4.99929236820E-12 -5.07828536846E-12 -5.15719415928E-12 -5.23692358811E-12 -5.31576908451E-12 -5.39506772979E-12 -5.47388075695E-12 -5.55234342311E-12 -5.63033488191E-12 -5.70741156436E-12 -5.78587632171E-12 -5.85886216510E-12 -5.93669135510E-12 -6.00694782657E-12 -6.08219239600E-12 -6.15144494178E-12 -6.21748685923E-12 -6.28849666627E-12 -6.35104549694E-12 -6.41175723763E-12 -6.46957257729E-12 -6.52750848046E-12 -6.57828521582E-12 -6.62890024851E-12 -6.67125064352E-12 -6.71233261551E-12 -6.74223766975E-12 -6.77943451222E-12 -6.79923970041E-12 -6.81536102937E-12 -6.82522657822E-12 -6.83125935485E-12 -6.82796335891E-12 -6.80892832728E-12 -6.78639416428E-12 -6.75939859053E-12 -6.70894144872E-12 -6.66034289284E-12 -6.59236657198E-12 -6.50952536764E-12 -6.41389527518E-12 -6.30833049882E-12 -6.18238498900E-12 -6.04507710384E-12 -5.86972949958E-12 -5.70126034449E-12 -5.49525238532E-12 -5.27166617022E-12 -5.02424767999E-12 -4.74561647733E-12 -4.45782150016E-12 -4.11862858024E-12 -3.76235439045E-12 -3.37449545715E-12 -2.94176800796E-12 -2.47961566794E-12 -1.98719871528E-12 -1.42652840597E-12 -8.57574949511E-13 -2.10562865663E-13 4.78475857760E-13 1.18490183854E-12 2.00731362908E-12 2.85060624635E-12 3.75826374529E-12 4.73938158056E-12 5.78651645436E-12 6.92065768824E-12 8.11197859464E-12 9.41416761633E-12 1.07683028333E-11 1.22585672800E-11 1.38226709345E-11 1.54642010690E-11 1.72947291457E-11 1.91670256663E-11 2.11886602596E-11 2.33670828824E-11 2.56539489727E-11 2.80651673015E-11 3.06995861636E-11 3.34302197693E-11 3.63822243432E-11 3.94965475732E-11 4.27795525234E-11 4.63292050164E-11 5.00426395633E-11 5.39600968655E-11 5.82126721656E-11 6.26476955691E-11 6.73236361693E-11 7.23657486959E-11 7.76432669741E-11 8.32673714738E-11 8.91944576870E-11 9.54934838018E-11 1.02189589503E-10 1.09189679327E-10 1.16708088570E-10 1.24587498992E-10 1.32944315840E-10 1.41776236083E-10 1.51185378043E-10 1.60984916268E-10 1.71520156734E-10 1.82567230716E-10 1.94237737546E-10 2.06569505027E-10 2.19614920850E-10 2.33476182732E-10 2.47991478198E-10 2.63367817750E-10 2.79688575385E-10 2.96763751923E-10 3.14983170006E-10 3.34065729147E-10 3.54243405059E-10 3.75713450623E-10 3.98051249921E-10 4.21919838894E-10 4.47041833381E-10 4.73383100343E-10 5.01417417160E-10 5.30871803932E-10 5.61920887915E-10 5.94717689132E-10 6.29309518002E-10 6.65807870138E-10 7.04315849334E-10 7.44840844339E-10 7.87672632881E-10 8.32749332392E-10 8.80339766533E-10 9.30557057514E-10 9.83323038153E-10 1.03923603914E-09 1.09785341272E-09 1.15977945466E-09 1.22523381990E-09 1.29388582568E-09 1.36634737884E-09 1.44298463953E-09 1.52326042355E-09 1.60835337937E-09 1.69752509659E-09 1.79191793761E-09 1.89100280567E-09 1.99568774221E-09 2.10575206510E-09 2.22183500704E-09 2.34402492308E-09 2.47271503899E-09 2.60851923443E-09 2.75125314754E-09 2.90156750025E-09 3.06024331864E-09 3.22686342159E-09 3.40272571475E-09 3.58773206084E-09 3.78255606681E-09 3.98788984560E-09 4.20377549836E-09 4.43135288370E-09 4.67078477849E-09 4.92319062748E-09 5.18854192640E-09 5.46788751326E-09 5.76268247752E-09 6.07206753689E-09 6.39828008454E-09 6.74190070505E-09 7.10288973624E-09 7.48372406145E-09 7.88391980546E-09 8.30547343351E-09 8.74920401014E-09 9.21618162191E-09 9.70759820302E-09 1.02250167484E-08 1.07693473469E-08 1.13424185581E-08 1.19454062448E-08 1.25800071533E-08 1.32480320083E-08 1.39504577725E-08 1.46907529548E-08 1.54683822231E-08 1.62878137560E-08 1.71496484233E-08 1.80563860250E-08 1.90106688315E-08 2.00148383304E-08 2.10712145146E-08 2.21831508271E-08 2.33525445553E-08 2.45833592642E-08 2.58780781216E-08 2.72404303376E-08 2.86738050108E-08 3.01817973185E-08 3.17683227078E-08 3.34370229745E-08 3.51937486714E-08 3.70404119725E-08 3.89845255747E-08 4.10285933899E-08 4.31796404382E-08 4.54422261931E-08 4.78225116424E-08 5.03264546063E-08 5.29601642287E-08 5.57315670868E-08 5.86452743307E-08 6.17117201024E-08 6.49370209793E-08 6.83291200772E-08 7.18970773854E-08 7.56507816695E-08 7.95992634521E-08 8.37512062141E-08 8.81197848864E-08 9.27135162993E-08 9.75465160131E-08 1.02628686758E-07 1.07975032424E-07 1.13597410859E-07 1.19511793316E-07 1.25731950179E-07 1.32272948936E-07 1.39154380242E-07 1.46390725553E-07 1.54001828294E-07 1.62006396271E-07 1.70424331059E-07 1.79278533330E-07 1.88590365811E-07 1.98383086063E-07 2.08682404384E-07 2.19513273083E-07 2.30904476492E-07 2.42884740531E-07 2.55481508357E-07 2.68732114815E-07 2.82663781979E-07 2.97318084128E-07 3.12726538446E-07 3.28931561459E-07 3.45971621662E-07 3.63893815812E-07 3.82738316026E-07 4.02556633935E-07 4.23396825083E-07 4.45312882126E-07 4.68357739591E-07 4.92593277015E-07 5.18076607726E-07 5.44875762179E-07 5.73056052248E-07 6.02688585862E-07 6.33849677244E-07 6.66615135349E-07 7.01072546119E-07 7.37302480502E-07 7.75401126633E-07 8.15462120199E-07 8.57586978733E-07 9.01882753724E-07 9.48458827758E-07 9.97437045680E-07 1.04893339398E-06 1.10308375265E-06 1.16002395420E-06 1.21989389988E-06 1.28284699961E-06 1.34904150294E-06 1.41864125935E-06 1.49182802544E-06 1.56877700520E-06 1.64968822715E-06 1.73476362199E-06 1.82421661391E-06 1.91827137412E-06 2.01716578778E-06 2.12114912227E-06 2.23047908278E-06 2.34543646311E-06 2.46630288708E-06 2.59338838586E-06 2.72700934968E-06 2.86750097703E-06 3.01521616044E-06 3.17053088683E-06 3.33382564631E-06 3.50551965832E-06 3.68603848859E-06 3.87583496843E-06 4.07539368193E-06 4.28520097931E-06 4.50579996399E-06 4.73772904473E-06 4.98158204707E-06 5.23795978549E-06 5.50751997761E-06 5.79091950881E-06 6.08888697314E-06 6.40215963265E-06 6.73152469316E-06 7.07780971768E-06 7.44187829907E-06 7.82464926938E-06 8.22708047169E-06 8.65017084020E-06 9.09499595538E-06 9.56265857078E-06 1.00543341256E-05 1.05712499983E-05 1.11147146649E-05 1.16860657757E-05 1.22867538309E-05 1.29182774953E-05 1.35822057062E-05 1.42802198350E-05 1.50140487847E-05 1.57855404384E-05 1.65966179898E-05 1.74493121080E-05 1.83457586347E-05 1.92881941724E-05 2.02789733307E-05 2.13205854339E-05 2.24156203635E-05 2.35668141964E-05 2.47770591078E-05 2.60493639249E-05 2.73869068797E-05 2.87930416850E-05 3.02712628993E-05 3.18252722799E-05 3.34589451092E-05 3.51763637988E-05 3.69817986742E-05 3.88797769053E-05 4.08750127601E-05 4.29724890972E-05 4.51774401194E-05 4.74953634009E-05 4.99320161339E-05 5.24935020082E-05 5.51861761085E-05 5.80167526469E-05 6.09922888813E-05 6.41201736316E-05 6.74082203428E-05 7.08645669377E-05 7.44978678601E-05 7.83170988068E-05 8.23318078934E-05 8.65519287437E-05 9.09879808515E-05 9.56509663090E-05 1.00552469538E-04 1.05704646366E-04 1.11120310641E-04 1.16812853555E-04 1.22796439463E-04 1.29085860410E-04 1.35696719026E-04 1.42645405664E-04 1.49949084453E-04 1.57625859780E-04 1.65694745736E-04 1.74175620084E-04 1.83089537509E-04 1.92458438066E-04 2.02305518579E-04 2.12655036126E-04 2.23532533649E-04 2.34964854343E-04 2.46980136510E-04 2.59607955753E-04 2.72879435798E-04 2.86827195753E-04 3.01485482594E-04 3.16890386529E-04 3.33079633625E-04 3.50092976353E-04 3.67972126300E-04 3.86760851209E-04 4.06505131863E-04 4.27253262795E-04 4.49055926691E-04 4.71966346029E-04 4.96040409177E-04 5.21336737509E-04 5.47916956614E-04 5.75845652466E-04 6.05190688961E-04 6.36023269902E-04 6.68418131659E-04 7.02453688435E-04 7.38212218074E-04 7.75780093642E-04 8.15247923172E-04 8.56710719000E-04 9.00268246677E-04 9.46025073559E-04 9.94090909264E-04 1.04458082701E-03 1.09761551625E-03 1.15332144687E-03 1.21183138208E-03 1.27328427705E-03 1.33782606939E-03 1.40560947498E-03 1.47679469008E-03 1.55154954031E-03 1.63004989569E-03 1.71247990110E-03 1.79903257212E-03 1.88991000896E-03 1.98532378594E-03 2.08549548920E-03 2.19065705454E-03 2.30105120183E-03 2.41693200925E-03 2.53856509903E-03 2.66622861890E-03 2.80021311388E-03 2.94082262667E-03 3.08837481931E-03 3.24320173743E-03 3.40565022274E-03 3.57608256977E-03 3.75487712303E-03 3.94242870261E-03 4.13914937393E-03 4.34546902720E-03 4.56183578344E-03 4.78871687902E-03 5.02659913053E-03 5.27598950751E-03 5.53741572010E-03 5.81142709043E-03 6.09859451737E-03 6.39951176210E-03 6.71479547438E-03 7.04508571528E-03 7.39104678219E-03 7.75336713607E-03 8.13276006860E-03 8.52996402589E-03 8.94574251134E-03 9.38088450244E-03 9.83620442471E-03 1.03125417834E-02 1.08107614691E-02 1.13317526546E-02 1.18764289363E-02 1.24457269900E-02 1.30406058988E-02 1.36620458189E-02 1.43110463726E-02 1.49886248049E-02 1.56958138089E-02 1.64336588873E-02 1.72032148931E-02 1.80055432775E-02 1.88417066079E-02 1.97127654495E-02 2.06197708594E-02 2.15637602611E-02 2.25457482864E-02 2.35667203172E-02 2.46276222130E-02 2.57293505998E-02 2.68727413606E-02 2.80585559752E-02 2.92874678709E-02 3.05600455806E-02 3.18767349273E-02 3.32378386818E-02 3.46434945009E-02 3.60936496227E-02 3.75880341318E-02 3.91261296112E-02 4.07071365376E-02 4.23299365444E-02 4.39930522353E-02 4.56946021613E-02 4.74322518094E-02 4.92031596547E-02 5.10039188668E-02 5.28304918493E-02 5.46781417650E-02 5.65413547914E-02 5.84137577978E-02 6.02880287169E-02 6.21557987615E-02 6.40075474541E-02 6.58324894109E-02 6.76184526906E-02 6.93517480773E-02 7.10170293300E-02 7.25971450170E-02 7.40729795402E-02 7.54232870358E-02 7.66245134433E-02 7.76506134453E-02 7.84728555724E-02 7.90596228484E-02 7.93762063293E-02 7.93845933582E-02 7.90432541151E-02 7.83069278779E-02 7.71264103804E-02 7.54483497152E-02 7.32150505963E-02 7.03642958484E-02 6.68291891146E-02 6.25380259602E-02 5.74142032852E-02 5.13761744109E-02 4.43374621181E-02 3.62067425373E-02 2.68880109536E-02 1.62808500111E-02 4.28081233046E-03 -9.22005893609E-03 -2.43325536778E-02 -4.11694392071E-02 -5.98444010178E-02 -8.04707566755E-02 -1.03159915358E-01 -1.28019559489E-01 -1.55151521182E-01 -1.84649331999E-01 -2.16595426422E-01 -2.51057978996E-01 -2.88087372479E-01 -3.27712292688E-01 -3.69935460166E-01 -4.14729032095E-01 -4.62029712377E-01 -5.11733642522E-01 -5.63691171812E-01 -6.17701630505E-01 -6.73508279829E-01 -7.30793647655E-01 -7.89175507995E-01 -8.48203822452E-01 -9.07359003856E-01 -9.66051934475E-01 -1.02362620612E+00 -1.07936311012E+00 -1.13248992293E+00 -1.18219204518E+00 -1.22762952701E+00 -1.26795842416E+00 -1.30235730844E+00 -1.33005900124E+00 -1.35038729445E+00 -1.36279792693E+00 -1.36692248353E+00 -1.36261306651E+00 -1.34998461119E+00 -1.32945053509E+00 -1.30174610594E+00 -1.26793252330E+00 -1.22937346422E+00 -1.18767495988E+00 -1.14457949146E+00 -1.10180679649E+00 -1.06083822622E+00 -1.02265024051E+00 -9.87418258562E-01 -9.54238148954E-01 -9.20954309599E-01 -8.84247836067E-01 -8.36422901015E-01 -7.54177203456E-01 -6.28799375202E-01 -4.58836633639E-01 -2.58740062224E-01 -7.40943060298E-02 8.18660989999E-04 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 6 2 Beta L 627 0.00000000000E+00 -2.01906443807E-17 -3.32714678890E-11 -3.06400196496E-11 -3.15567304373E-11 -3.21347832478E-11 -3.27572683901E-11 -3.33866135242E-11 -3.40266242542E-11 -3.46771366298E-11 -3.53381697598E-11 -3.60100590378E-11 -3.66928210979E-11 -3.73863879416E-11 -3.80914828404E-11 -3.88073596955E-11 -3.95348051794E-11 -4.02738382193E-11 -4.10242855340E-11 -4.17866009261E-11 -4.25603069878E-11 -4.33467351749E-11 -4.41438050615E-11 -4.49545159525E-11 -4.57765164238E-11 -4.66106232239E-11 -4.74576314499E-11 -4.83164477661E-11 -4.91887824240E-11 -5.00708314685E-11 -5.09697062319E-11 -5.18763908478E-11 -5.27999159316E-11 -5.37331364850E-11 -5.46791887129E-11 -5.56394963297E-11 -5.66096361320E-11 -5.75947712294E-11 -5.85901646507E-11 -5.95998223861E-11 -6.06192233032E-11 -6.16528348588E-11 -6.26976649468E-11 -6.37507775345E-11 -6.48224339631E-11 -6.58974412523E-11 -6.69906242284E-11 -6.80859330451E-11 -6.91997743858E-11 -7.03232398201E-11 -7.14471847119E-11 -7.25866239101E-11 -7.37380052071E-11 -7.48929764819E-11 -7.60554064966E-11 -7.72260287056E-11 -7.83988424726E-11 -7.95821554593E-11 -8.07686694304E-11 -8.19631618227E-11 -8.31466752618E-11 -8.43445316203E-11 -8.55409105757E-11 -8.67387107815E-11 -8.79262682183E-11 -8.91106195673E-11 -9.03069933605E-11 -9.14878241159E-11 -9.26467854071E-11 -9.38168419350E-11 -9.49630553209E-11 -9.60987866288E-11 -9.72246463506E-11 -9.83259421156E-11 -9.94073790674E-11 -1.00466392882E-10 -1.01491200939E-10 -1.02511264902E-10 -1.03477793557E-10 -1.04414494656E-10 -1.05309678792E-10 -1.06169470434E-10 -1.06987049211E-10 -1.07722291524E-10 -1.08442283740E-10 -1.09076893805E-10 -1.09652184928E-10 -1.10160719618E-10 -1.10584079430E-10 -1.10918886590E-10 -1.11200938028E-10 -1.11331873211E-10 -1.11397243580E-10 -1.11365055139E-10 -1.11130005418E-10 -1.10880642856E-10 -1.10419818305E-10 -1.09831946110E-10 -1.09080960804E-10 -1.08162770027E-10 -1.07085065365E-10 -1.05782879737E-10 -1.04319412398E-10 -1.02569989805E-10 -1.00663464521E-10 -9.84847149156E-11 -9.59677648276E-11 -9.33120909672E-11 -9.02433178697E-11 -8.68958353910E-11 -8.32445858437E-11 -7.91783022626E-11 -7.47303328113E-11 -6.99563858959E-11 -6.46498031757E-11 -5.89877300729E-11 -5.27937755532E-11 -4.60494351487E-11 -3.88566812934E-11 -3.10452387559E-11 -2.25530857357E-11 -1.35678122032E-11 -3.80311440534E-12 6.71908941368E-12 1.79220634472E-11 2.99636688986E-11 4.28370020826E-11 5.66881749163E-11 7.14305899091E-11 8.71534015104E-11 1.04102257890E-10 1.21993206855E-10 1.41165141816E-10 1.61615261865E-10 1.83416806971E-10 2.06492533724E-10 2.31302552355E-10 2.57429588989E-10 2.85327447224E-10 3.15056936861E-10 3.46529114029E-10 3.80037952372E-10 4.15445119401E-10 4.53231798167E-10 4.93265422463E-10 5.35588380324E-10 5.80753146916E-10 6.28248745974E-10 6.78893654441E-10 7.32513647232E-10 7.88988020725E-10 8.49311581532E-10 9.12776524411E-10 9.79973613196E-10 1.05144553701E-09 1.12654969926E-09 1.20631578621E-09 1.29067433423E-09 1.37980856261E-09 1.47404475085E-09 1.57364132987E-09 1.67894340967E-09 1.79020195209E-09 1.90773216869E-09 2.03199879544E-09 2.16315910865E-09 2.30160475749E-09 2.44810944560E-09 2.60225674122E-09 2.76567388510E-09 2.93767961682E-09 3.11928138313E-09 3.31121658254E-09 3.51364042741E-09 3.72687117022E-09 3.95246576235E-09 4.18992760562E-09 4.44078061708E-09 4.70503690770E-09 4.98411100421E-09 5.27806967920E-09 5.58835378805E-09 5.91526124884E-09 6.26010232696E-09 6.62378997981E-09 7.00652791508E-09 7.41071276453E-09 7.83660643081E-09 8.28500536446E-09 8.75830898542E-09 9.25643187711E-09 9.78171827363E-09 1.03351000652E-08 1.09180128341E-08 1.15325645695E-08 1.21796859848E-08 1.28617070190E-08 1.35796148910E-08 1.43365117003E-08 1.51338908475E-08 1.59723596866E-08 1.68572558359E-08 1.77883461206E-08 1.87685140770E-08 1.98019401185E-08 2.08888236851E-08 2.20344313488E-08 2.32403795131E-08 2.45097286190E-08 2.58467986500E-08 2.72544389045E-08 2.87361258040E-08 3.02965329056E-08 3.19388543203E-08 3.36681912548E-08 3.54881488115E-08 3.74041912668E-08 3.94216615884E-08 4.15437088356E-08 4.37794063675E-08 4.61309043828E-08 4.86064936351E-08 5.12125021456E-08 5.39544320109E-08 5.68405892070E-08 5.98781505346E-08 6.30742094290E-08 6.64386491983E-08 6.99782838412E-08 7.37038958389E-08 7.76235774863E-08 8.17486856059E-08 8.60891950742E-08 9.06564620113E-08 9.54629889442E-08 1.00518338617E-07 1.05840064642E-07 1.11437205034E-07 1.17327586868E-07 1.23524393413E-07 1.30044257994E-07 1.36903751070E-07 1.44120194472E-07 1.51713191323E-07 1.59699350853E-07 1.68104068975E-07 1.76943170659E-07 1.86242382090E-07 1.96026378215E-07 2.06317839888E-07 2.17143999707E-07 2.28531672536E-07 2.40512831789E-07 2.53113908747E-07 2.66370418215E-07 2.80313391625E-07 2.94981341917E-07 3.10408522939E-07 3.26636889726E-07 3.43705369692E-07 3.61659012120E-07 3.80544989123E-07 4.00405852440E-07 4.21298411694E-07 4.43270675583E-07 4.66382242362E-07 4.90691112960E-07 5.16256220679E-07 5.43145097327E-07 5.71425474216E-07 6.01168710995E-07 6.32451031347E-07 6.65350381949E-07 6.99949851371E-07 7.36341877287E-07 7.74610020603E-07 8.14861187139E-07 8.57186726848E-07 9.01704618995E-07 9.48518068360E-07 9.97753761387E-07 1.04952775854E-06 1.10397898173E-06 1.16123968675E-06 1.22145786589E-06 1.28478265358E-06 1.35137888934E-06 1.42140872870E-06 1.49505525381E-06 1.57249878232E-06 1.65393877895E-06 1.73958063773E-06 1.82963807179E-06 1.92434364606E-06 2.02392566474E-06 2.12864946416E-06 2.23876920287E-06 2.35456692188E-06 2.47633323192E-06 2.60437506730E-06 2.73901733489E-06 2.88059334942E-06 3.02947179175E-06 3.18601698991E-06 3.35062502049E-06 3.52371675923E-06 3.70572224071E-06 3.89710222167E-06 4.09834280918E-06 4.30993726092E-06 4.53243684025E-06 4.76639005451E-06 5.01238707401E-06 5.27104965174E-06 5.54302933675E-06 5.82900863853E-06 6.12970550025E-06 6.44588387309E-06 6.77832820596E-06 7.12788701587E-06 7.49543068679E-06 7.88188560916E-06 8.28822706264E-06 8.71547815179E-06 9.16469730945E-06 9.63704057684E-06 1.01336734894E-05 1.06558551630E-05 1.12048993270E-05 1.17821717209E-05 1.23891486904E-05 1.30273261530E-05 1.36983345001E-05 1.44038400656E-05 1.51456319321E-05 1.59255530940E-05 1.67455895231E-05 1.76077770920E-05 1.85142970183E-05 1.94674156908E-05 2.04695366432E-05 2.15231752529E-05 2.26309691121E-05 2.37957042782E-05 2.50203183680E-05 2.63078642878E-05 2.76615891156E-05 2.90848910067E-05 3.05813446541E-05 3.21546883355E-05 3.38089061930E-05 3.55481199235E-05 3.73767036840E-05 3.92992693200E-05 4.13205995000E-05 4.34458096010E-05 4.56802099070E-05 4.80294146032E-05 5.04993239991E-05 5.30961243194E-05 5.58263459024E-05 5.86968392191E-05 6.17147912563E-05 6.48877923036E-05 6.82238104144E-05 7.17311872309E-05 7.54187506963E-05 7.92957507378E-05 8.33718995618E-05 8.76574380355E-05 9.21631201546E-05 9.69002433543E-05 1.01880692251E-04 1.07116982299E-04 1.12622218652E-04 1.18410246104E-04 1.24495574170E-04 1.30893464321E-04 1.37619969270E-04 1.44691995546E-04 1.52127242162E-04 1.59944397479E-04 1.68163071904E-04 1.76803872146E-04 1.85888498873E-04 1.95439719883E-04 2.05481558817E-04 2.16039129093E-04 2.27139015605E-04 2.38808994778E-04 2.51078420645E-04 2.63978030901E-04 2.77540231220E-04 2.91799044926E-04 3.06790287017E-04 3.22551533584E-04 3.39122418909E-04 3.56544464526E-04 3.74861466247E-04 3.94119395908E-04 4.14366542193E-04 4.35653850721E-04 4.58034697523E-04 4.81565255115E-04 5.06304735494E-04 5.32315113899E-04 5.59661854581E-04 5.88413543634E-04 6.18642472359E-04 6.50424566449E-04 6.83839625000E-04 7.18971656489E-04 7.55908964610E-04 7.94744295346E-04 8.35575302241E-04 8.78504632170E-04 9.23640125735E-04 9.71095345016E-04 1.02098955758E-03 1.07344821319E-03 1.12860327032E-03 1.18659344823E-03 1.24756460127E-03 1.31167013824E-03 1.37907134536E-03 1.44993781267E-03 1.52444795594E-03 1.60278923852E-03 1.68515896168E-03 1.77176448885E-03 1.86282387793E-03 1.95856650648E-03 2.05923351762E-03 2.16507857609E-03 2.27636832718E-03 2.39338324803E-03 2.51641831346E-03 2.64578364260E-03 2.78180543633E-03 2.92482672618E-03 3.07520824090E-03 3.23332928251E-03 3.39958891664E-03 3.57440653975E-03 3.75822360067E-03 3.95150385535E-03 4.15473552813E-03 4.36843169385E-03 4.59313211894E-03 4.82940433307E-03 5.07784539118E-03 5.33908297389E-03 5.61377726234E-03 5.90262263853E-03 6.20634924848E-03 6.52572497956E-03 6.86155741931E-03 7.21469574589E-03 7.58603326662E-03 7.97650897131E-03 8.38711073170E-03 8.81887718421E-03 9.27290055107E-03 9.75032942251E-03 1.02523716134E-02 1.07802971480E-02 1.13354414155E-02 1.19192086371E-02 1.25330752597E-02 1.31785934490E-02 1.38573954498E-02 1.45711969943E-02 1.53218018738E-02 1.61111063422E-02 1.69411037907E-02 1.78138890665E-02 1.87316646737E-02 1.96967447094E-02 2.07115612963E-02 2.17786703624E-02 2.29007569469E-02 2.40806425708E-02 2.53212907735E-02 2.66258144584E-02 2.79974834156E-02 2.94397305220E-02 3.09561608957E-02 3.25505586224E-02 3.42268958679E-02 3.59893408762E-02 3.78422673589E-02 3.97902628447E-02 4.18381392319E-02 4.39909409015E-02 4.62539564623E-02 4.86327269980E-02 5.11330583071E-02 5.37610295060E-02 5.65230057640E-02 5.94256473330E-02 6.24759216881E-02 6.56811134403E-02 6.90488363547E-02 7.25870426925E-02 7.63040349502E-02 8.02084754954E-02 8.43093961531E-02 8.86162085621E-02 9.31387106798E-02 9.78870976782E-02 1.02871965039E-01 1.08104317377E-01 1.13595569874E-01 1.19357552445E-01 1.25402509354E-01 1.31743096800E-01 1.38392379321E-01 1.45363820958E-01 1.52671275427E-01 1.60328969244E-01 1.68351484196E-01 1.76753730390E-01 1.85550918385E-01 1.94758520280E-01 2.04392227740E-01 2.14467899534E-01 2.25001501658E-01 2.36009037045E-01 2.47506466290E-01 2.59509614601E-01 2.72034066917E-01 2.85095051445E-01 2.98707303379E-01 3.12884918079E-01 3.27641181120E-01 3.42988385883E-01 3.58937623477E-01 3.75498560294E-01 3.92679183334E-01 4.10485532748E-01 4.28921397687E-01 4.47987999166E-01 4.67683635957E-01 4.88003310941E-01 5.08938328739E-01 5.30475865510E-01 5.52598516300E-01 5.75283815854E-01 5.98503740271E-01 6.22224186048E-01 6.46404439697E-01 6.70996630197E-01 6.95945186751E-01 7.21186290845E-01 7.46647350919E-01 7.72246492940E-01 7.97892094203E-01 8.23482365047E-01 8.48905000298E-01 8.74036919488E-01 8.98744112009E-01 9.22881620070E-01 9.46293672733E-01 9.68814010273E-01 9.90266415378E-01 1.01046549206E+00 1.02921770890E+00 1.04632274680E+00 1.06157516227E+00 1.07476640514E+00 1.08568718046E+00 1.09413018683E+00 1.09989320069E+00 1.10278249518E+00 1.10261655126E+00 1.09922998297E+00 1.09247759151E+00 1.08223840624E+00 1.06841954572E+00 1.05095967420E+00 1.02983179830E+00 1.00504506590E+00 9.76645220841E-01 9.44713265117E-01 9.09361900086E-01 8.70729231775E-01 8.28969287630E-01 7.84238878489E-01 7.36680471557E-01 6.86400889721E-01 6.33445909156E-01 5.77771256127E-01 5.19210994776E-01 4.57445119431E-01 3.91969074241E-01 3.22069240688E-01 2.46809933728E-01 1.65039358127E-01 7.54240942161E-02 -2.34758845462E-02 -1.33077247596E-01 -2.54571656162E-01 -3.88634124519E-01 -5.35022814077E-01 -6.92053982197E-01 -8.55942248259E-01 -1.02000944364E+00 -1.17378863599E+00 -1.30208853233E+00 -1.38414460834E+00 -1.39307702124E+00 -1.31054109273E+00 -1.17327670048E+00 -9.70630367671E-01 -7.02456435725E-01 -3.92594233267E-01 -1.10774587580E-01 2.21696686966E-03 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 9 Number of nonzero Dij 1 1 1.81213232144E-01 1 2 3.70549966463E+00 2 2 -3.06932326910E+00 3 3 -1.75259199573E+00 3 4 3.77872885451E+00 4 4 -1.23050699660E+00 5 5 1.18926255979E+00 5 6 -2.82957147603E+00 6 6 6.59070714910E+00 8 nqf. If not zero, Qij's inside rinner are computed using qfcoef's 1 9.00000000000E-01 2 9.00000000000E-01 3 9.00000000000E-01 4 9.00000000000E-01 5 9.00000000000E-01 1 1 0 i j (l(j)) -6.00817150380E-01 Q_int 0.00000000000E+00 -4.47161134812E-13 -1.81883139255E-12 -4.16162999528E-12 -7.52401317886E-12 -1.19563407755E-11 -1.75109451258E-11 -2.42422024003E-11 -3.22066064132E-11 -4.14628450150E-11 -5.20718791514E-11 -6.40970246810E-11 -7.76040370462E-11 -9.26611988962E-11 -1.09339410762E-10 -1.27712284890E-10 -1.47856242342E-10 -1.69850613472E-10 -1.93777741897E-10 -2.19723092088E-10 -2.47775360690E-10 -2.78026591715E-10 -3.10572295735E-10 -3.45511573205E-10 -3.82947242068E-10 -4.22985969788E-10 -4.65738409954E-10 -5.11319343620E-10 -5.59847825538E-10 -6.11447335461E-10 -6.66245934673E-10 -7.24376427938E-10 -7.85976531062E-10 -8.51189044223E-10 -9.20162031320E-10 -9.93049005500E-10 -1.07000912110E-09 -1.15120737221E-09 -1.23681479810E-09 -1.32700869574E-09 -1.42197283964E-09 -1.52189770925E-09 -1.62698072426E-09 -1.73742648795E-09 -1.85344703897E-09 -1.97526211173E-09 -2.10309940588E-09 -2.23719486491E-09 -2.37779296446E-09 -2.52514701048E-09 -2.67951944773E-09 -2.84118217877E-09 -3.01041689403E-09 -3.18751541318E-09 -3.37278003821E-09 -3.56652391870E-09 -3.76907142956E-09 -3.98075856188E-09 -4.20193332699E-09 -4.43295617459E-09 -4.67420042515E-09 -4.92605271714E-09 -5.18891346960E-09 -5.46319736061E-09 -5.74933382216E-09 -6.04776755195E-09 -6.35895904284E-09 -6.68338513025E-09 -7.02153955858E-09 -7.37393356680E-09 -7.74109649424E-09 -8.12357640708E-09 -8.52194074638E-09 -8.93677699800E-09 -9.36869338600E-09 -9.81831958917E-09 -1.02863074825E-08 -1.07733319038E-08 -1.12800914467E-08 -1.18073092809E-08 -1.23557339996E-08 -1.29261404975E-08 -1.35193308772E-08 -1.41361353877E-08 -1.47774133943E-08 -1.54440543821E-08 -1.61369789937E-08 -1.68571401019E-08 -1.76055239199E-08 -1.83831511486E-08 -1.91910781634E-08 -2.00303982421E-08 -2.09022428334E-08 -2.18077828700E-08 -2.27482301260E-08 -2.37248386206E-08 -2.47389060696E-08 -2.57917753871E-08 -2.68848362373E-08 -2.80195266404E-08 -2.91973346326E-08 -3.04197999830E-08 -3.16885159690E-08 -3.30051312120E-08 -3.43713515763E-08 -3.57889421321E-08 -3.72597291861E-08 -3.87856023804E-08 -4.03685168642E-08 -4.20104955383E-08 -4.37136313768E-08 -4.54800898282E-08 -4.73121112970E-08 -4.92120137120E-08 -5.11821951798E-08 -5.32251367304E-08 -5.53434051557E-08 -5.75396559447E-08 -5.98166363185E-08 -6.21771883696E-08 -6.46242523064E-08 -6.71608698105E-08 -6.97901875061E-08 -7.25154605490E-08 -7.53400563375E-08 -7.82674583489E-08 -8.13012701079E-08 -8.44452192889E-08 -8.77031619593E-08 -9.10790869659E-08 -9.45771204708E-08 -9.82015306430E-08 -1.01956732508E-07 -1.05847292965E-07 -1.09877935969E-07 -1.14053547899E-07 -1.18379183098E-07 -1.22860069612E-07 -1.27501615113E-07 -1.32309413036E-07 -1.37289248914E-07 -1.42447106933E-07 -1.47789176715E-07 -1.53321860322E-07 -1.59051779503E-07 -1.64985783191E-07 -1.71130955252E-07 -1.77494622491E-07 -1.84084362945E-07 -1.90908014447E-07 -1.97973683481E-07 -2.05289754346E-07 -2.12864898624E-07 -2.20708084978E-07 -2.28828589271E-07 -2.37236005044E-07 -2.45940254343E-07 -2.54951598907E-07 -2.64280651753E-07 -2.73938389144E-07 -2.83936162963E-07 -2.94285713514E-07 -3.04999182758E-07 -3.16089127992E-07 -3.27568536001E-07 -3.39450837693E-07 -3.51749923222E-07 -3.64480157628E-07 -3.77656397028E-07 -3.91294005322E-07 -4.05408871505E-07 -4.20017427538E-07 -4.35136666848E-07 -4.50784163446E-07 -4.66978091697E-07 -4.83737246768E-07 -5.01081065766E-07 -5.19029649599E-07 -5.37603785580E-07 -5.56824970798E-07 -5.76715436289E-07 -5.97298172026E-07 -6.18596952761E-07 -6.40636364748E-07 -6.63441833373E-07 -6.87039651729E-07 -7.11457010156E-07 -7.36722026800E-07 -7.62863779201E-07 -7.89912336952E-07 -8.17898795503E-07 -8.46855311068E-07 -8.76815136761E-07 -9.07812659938E-07 -9.39883440841E-07 -9.73064252518E-07 -1.00739312213E-06 -1.04290937368E-06 -1.07965367217E-06 -1.11766806925E-06 -1.15699605048E-06 -1.19768258418E-06 -1.23977417191E-06 -1.28331890070E-06 -1.32836649708E-06 -1.37496838296E-06 -1.42317773333E-06 -1.47304953604E-06 -1.52464065361E-06 -1.57800988701E-06 -1.63321804185E-06 -1.69032799662E-06 -1.74940477340E-06 -1.81051561091E-06 -1.87373004010E-06 -1.93911996231E-06 -2.00675973011E-06 -2.07672623088E-06 -2.14909897331E-06 -2.22396017678E-06 -2.30139486389E-06 -2.38149095608E-06 -2.46433937258E-06 -2.55003413276E-06 -2.63867246192E-06 -2.73035490078E-06 -2.82518541869E-06 -2.92327153077E-06 -3.02472441901E-06 -3.12965905758E-06 -3.23819434243E-06 -3.35045322536E-06 -3.46656285264E-06 -3.58665470854E-06 -3.71086476363E-06 -3.83933362836E-06 -3.97220671174E-06 -4.10963438572E-06 -4.25177215504E-06 -4.39878083306E-06 -4.55082672366E-06 -4.70808180934E-06 -4.87072394598E-06 -5.03893706413E-06 -5.21291137750E-06 -5.39284359854E-06 -5.57893716148E-06 -5.77140245323E-06 -5.97045705214E-06 -6.17632597525E-06 -6.38924193396E-06 -6.60944559871E-06 -6.83718587290E-06 -7.07272017618E-06 -7.31631473800E-06 -7.56824490094E-06 -7.82879543510E-06 -8.09826086317E-06 -8.37694579706E-06 -8.66516528634E-06 -8.96324517879E-06 -9.27152249382E-06 -9.59034580887E-06 -9.92007565948E-06 -1.02610849535E-05 -1.06137594002E-05 -1.09784979535E-05 -1.13557132729E-05 -1.17458321983E-05 -1.21492962439E-05 -1.25665621082E-05 -1.29981022029E-05 -1.34444052005E-05 -1.39059766012E-05 -1.43833393204E-05 -1.48770342978E-05 -1.53876211267E-05 -1.59156787083E-05 -1.64618059271E-05 -1.70266223530E-05 -1.76107689671E-05 -1.82149089147E-05 -1.88397282855E-05 -1.94859369221E-05 -2.01542692581E-05 -2.08454851868E-05 -2.15603709619E-05 -2.22997401310E-05 -2.30644345037E-05 -2.38553251558E-05 -2.46733134697E-05 -2.55193322144E-05 -2.63943466654E-05 -2.72993557662E-05 -2.82353933331E-05 -2.92035293059E-05 -3.02048710451E-05 -3.12405646781E-05 -3.23117964969E-05 -3.34197944079E-05 -3.45658294383E-05 -3.57512172985E-05 -3.69773200060E-05 -3.82455475705E-05 -3.95573597454E-05 -4.09142678451E-05 -4.23178366361E-05 -4.37696862986E-05 -4.52714944673E-05 -4.68249983519E-05 -4.84319969405E-05 -5.00943532920E-05 -5.18139969178E-05 -5.35929262605E-05 -5.54332112710E-05 -5.73369960903E-05 -5.93065018391E-05 -6.13440295216E-05 -6.34519630472E-05 -6.56327723766E-05 -6.78890167985E-05 -7.02233483403E-05 -7.26385153223E-05 -7.51373660593E-05 -7.77228527192E-05 -8.03980353435E-05 -8.31660860387E-05 -8.60302933469E-05 -8.89940668033E-05 -9.20609416906E-05 -9.52345839995E-05 -9.85187956052E-05 -1.01917519669E-04 -1.05434846283E-04 -1.09075018355E-04 -1.12842437766E-04 -1.16741671799E-04 -1.20777459851E-04 -1.24954720461E-04 -1.29278558648E-04 -1.33754273587E-04 -1.38387366642E-04 -1.43183549764E-04 -1.48148754291E-04 -1.53289140144E-04 -1.58611105470E-04 -1.64121296736E-04 -1.69826619303E-04 -1.75734248505E-04 -1.81851641269E-04 -1.88186548287E-04 -1.94747026789E-04 -2.01541453941E-04 -2.08578540895E-04 -2.15867347550E-04 -2.23417298034E-04 -2.31238196964E-04 -2.39340246537E-04 -2.47734064474E-04 -2.56430702881E-04 -2.65441668078E-04 -2.74778941451E-04 -2.84455001376E-04 -2.94482846293E-04 -3.04876018981E-04 -3.15648632113E-04 -3.26815395157E-04 -3.38391642717E-04 -3.50393364375E-04 -3.62837236141E-04 -3.75740653601E-04 -3.89121766857E-04 -4.02999517370E-04 -4.17393676828E-04 -4.32324888133E-04 -4.47814708666E-04 -4.63885655948E-04 -4.80561255840E-04 -4.97866093442E-04 -5.15825866860E-04 -5.34467443991E-04 -5.53818922538E-04 -5.73909693429E-04 -5.94770507865E-04 -6.16433548209E-04 -6.38932502939E-04 -6.62302645955E-04 -6.86580920455E-04 -7.11806027699E-04 -7.38018520957E-04 -7.65260904927E-04 -7.93577741038E-04 -8.23015758895E-04 -8.53623974350E-04 -8.85453814544E-04 -9.18559250384E-04 -9.52996936897E-04 -9.88826361969E-04 -1.02611000399E-03 -1.06491349895E-03 -1.10530581757E-03 -1.14735945312E-03 -1.19115062055E-03 -1.23675946772E-03 -1.28427029937E-03 -1.33377181466E-03 -1.38535735930E-03 -1.43912519285E-03 -1.49517877239E-03 -1.55362705360E-03 -1.61458481005E-03 -1.67817297221E-03 -1.74451898715E-03 -1.81375720024E-03 -1.88602926036E-03 -1.96148454990E-03 -2.04028064124E-03 -2.12258378123E-03 -2.20856940540E-03 -2.29842268391E-03 -2.39233910090E-03 -2.49052506952E-03 -2.59319858470E-03 -2.70058991613E-03 -2.81294234356E-03 -2.93051293739E-03 -3.05357338697E-03 -3.18241087974E-03 -3.31732903398E-03 -3.45864888862E-03 -3.60670995342E-03 -3.76187132308E-03 -3.92451285899E-03 -4.09503644277E-03 -4.27386730558E-03 -4.46145543779E-03 -4.65827708342E-03 -4.86483632441E-03 -5.08166675975E-03 -5.30933328469E-03 -5.54843397593E-03 -5.79960208822E-03 -6.06350816907E-03 -6.34086229733E-03 -6.63241645294E-03 -6.93896702424E-03 -7.26135746062E-03 -7.60048107744E-03 -7.95728402161E-03 -8.33276840530E-03 -8.72799561664E-03 -9.14408981546E-03 -9.58224162320E-03 -1.00437120160E-02 -1.05298364299E-02 -1.10420290876E-02 -1.15817875567E-02 -1.21506975481E-02 -1.27504379650E-02 -1.33827862116E-02 -1.40496237708E-02 -1.47529420609E-02 -1.54948485794E-02 -1.62775733430E-02 -1.71034756322E-02 -1.79750510469E-02 -1.88949388813E-02 -1.98659298221E-02 -2.08909739756E-02 -2.19731892267E-02 -2.31158699307E-02 -2.43224959379E-02 -2.55967419481E-02 -2.69424871896E-02 -2.83638254144E-02 -2.98650751973E-02 -3.14507905245E-02 -3.31257716495E-02 -3.48950761929E-02 -3.67640304543E-02 -3.87382408988E-02 -4.08236057755E-02 -4.30263268127E-02 -4.53529209316E-02 -4.78102319058E-02 -5.04054418857E-02 -5.31460826933E-02 -5.60400467817E-02 -5.90955977361E-02 -6.23213801824E-02 -6.57264289455E-02 -6.93201772884E-02 -7.31124640357E-02 -7.71135393707E-02 -8.13340690650E-02 -8.57851368815E-02 -9.04782448588E-02 -9.54253111631E-02 -1.00638665160E-01 -1.06131039333E-01 -1.11915557632E-01 -1.18005719828E-01 -1.24415381378E-01 -1.31158728323E-01 -1.38250246643E-01 -1.45704685543E-01 -1.53537014026E-01 -1.61762370164E-01 -1.70396002387E-01 -1.79453202146E-01 -1.88949227251E-01 -1.98899215213E-01 -2.09318085904E-01 -2.20220432881E-01 -2.31620402739E-01 -2.43531561926E-01 -2.55966750481E-01 -2.68937922312E-01 -2.82455971662E-01 -2.96530545630E-01 -3.11169842733E-01 -3.26380397727E-01 -3.42166853139E-01 -3.58531718246E-01 -3.75475116532E-01 -3.92994523057E-01 -4.11084493501E-01 -4.29736387127E-01 -4.48938086330E-01 -4.68673715912E-01 -4.88923365711E-01 -5.09662820664E-01 -5.30863302834E-01 -5.52491230283E-01 -5.74507997975E-01 -5.96869786019E-01 -6.19527400552E-01 -6.42426152261E-01 -6.65505777014E-01 -6.88700402138E-01 -7.11938560535E-01 -7.35143253045E-01 -7.58232057080E-01 -7.81117276686E-01 -8.03706125733E-01 -8.25900931976E-01 -8.47599345436E-01 -8.68694530075E-01 -8.89075313521E-01 -9.08626266103E-01 -9.27227678475E-01 -9.44755407633E-01 -9.61080565477E-01 -9.76069033912E-01 -9.89580807839E-01 -1.00146919456E+00 -1.01157993766E+00 -1.01975038805E+00 -1.02580891605E+00 -1.02957484798E+00 -1.03085931614E+00 -1.02946752723E+00 -1.02520306791E+00 -1.01787495281E+00 -1.00730813786E+00 -9.93358100336E-01 -9.75929716357E-01 -9.54999876559E-01 -9.30641812429E-01 -9.03046574915E-01 -8.72532946355E-01 -8.39530451380E-01 -8.04509871467E-01 -7.67839559276E-01 -7.29764830510E-01 -6.90529337799E-01 -6.50388823596E-01 -6.09608618659E-01 -5.68460820047E-01 -5.27221198410E-01 -4.86165892231E-01 -4.45567915297E-01 -4.05693572650E-01 -3.66798848585E-01 -3.29125912074E-01 -2.92899847813E-01 -2.58325796612E-01 -2.25586616968E-01 -1.94841200349E-01 -1.66223419172E-01 -1.39841620323E-01 -1.15778374512E-01 -9.40901539197E-02 -7.48065615115E-02 -5.79289297475E-02 -4.34283066372E-02 -3.12431520700E-02 -2.12772054770E-02 -1.33980503994E-02 -7.43680415280E-03 -3.18929803038E-03 -4.19103742136E-04 1.13710262162E-03 1.76114952871E-03 1.74109163691E-03 1.35423401236E-03 8.45187699089E-04 4.00149834137E-04 1.21689527077E-04 1.41528885418E-05 1.19966439866E-07 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 -3.73161709469E-01 -1.92140222283E+01 4.85171254695E+01 5.52498710798E+00 -2.00032293179E+02 3.63708122282E+02 -2.81459816372E+02 8.28739182584E+01 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1 2 0 i j (l(j)) 3.87092600843E-01 Q_int 0.00000000000E+00 8.95191516815E-12 3.64119845407E-11 8.33134987776E-11 1.50626524506E-10 2.39359237262E-10 3.50559301070E-10 4.85315296251E-10 6.44758197139E-10 8.30062901400E-10 1.04244981275E-09 1.28318647890E-09 1.55358928659E-09 1.85502521579E-09 2.18891365491E-09 2.55672827930E-09 2.95999899514E-09 3.40031395092E-09 3.87932161888E-09 4.39873294886E-09 4.96032359689E-09 5.56593623130E-09 6.21748291880E-09 6.91694759340E-09 7.66638861096E-09 8.46794139237E-09 9.32382115827E-09 1.02363257586E-08 1.12078386000E-08 1.22408316750E-08 1.33378686953E-08 1.45016083342E-08 1.57348075807E-08 1.70403252100E-08 1.84211253731E-08 1.98802813117E-08 2.14209792003E-08 2.30465221214E-08 2.47603341781E-08 2.65659647480E-08 2.84670928848E-08 3.04675318707E-08 3.25712339263E-08 3.47822950830E-08 3.71049602227E-08 3.95436282913E-08 4.21028576925E-08 4.47873718659E-08 4.76020650583E-08 5.05520082932E-08 5.36424555452E-08 5.68788501275E-08 6.02668312987E-08 6.38122410965E-08 6.75211314067E-08 7.13997712747E-08 7.54546544683E-08 7.96925073005E-08 8.41202967204E-08 8.87452386823E-08 9.35748068019E-08 9.86167413093E-08 1.03879058310E-07 1.09370059361E-07 1.15098341380E-07 1.21072806891E-07 1.27302674618E-07 1.33797490451E-07 1.40567138779E-07 1.47621854215E-07 1.54972233722E-07 1.62629249155E-07 1.70604260233E-07 1.78909027951E-07 1.87555728459E-07 1.96556967404E-07 2.05925794778E-07 2.15675720261E-07 2.25820729094E-07 2.36375298498E-07 2.47354414648E-07 2.58773590233E-07 2.70648882611E-07 2.82996912592E-07 2.95834883855E-07 3.09180603032E-07 3.23052500484E-07 3.37469651773E-07 3.52451799883E-07 3.68019378186E-07 3.84193534207E-07 4.00996154184E-07 4.18449888482E-07 4.36578177863E-07 4.55405280660E-07 4.74956300876E-07 4.95257217238E-07 5.16334913252E-07 5.38217208272E-07 5.60932889639E-07 5.84511745907E-07 6.08984601213E-07 6.34383350809E-07 6.60740997808E-07 6.88091691192E-07 7.16470765102E-07 7.45914779477E-07 7.76461562073E-07 8.08150251921E-07 8.41021344256E-07 8.75116736987E-07 9.10479778743E-07 9.47155318562E-07 9.85189757267E-07 1.02463110060E-06 1.06552901414E-06 1.10793488016E-06 1.15190185632E-06 1.19748493643E-06 1.24474101329E-06 1.29372894360E-06 1.34450961515E-06 1.39714601627E-06 1.45170330763E-06 1.50824889651E-06 1.56685251360E-06 1.62758629236E-06 1.69052485115E-06 1.75574537815E-06 1.82332771908E-06 1.89335446803E-06 1.96591106129E-06 2.04108587441E-06 2.11897032257E-06 2.19965896431E-06 2.28324960886E-06 2.36984342708E-06 2.45954506618E-06 2.55246276834E-06 2.64870849336E-06 2.74839804548E-06 2.85165120456E-06 2.95859186162E-06 3.06934815909E-06 3.18405263576E-06 3.30284237670E-06 3.42585916825E-06 3.55324965827E-06 3.68516552190E-06 3.82176363284E-06 3.96320624058E-06 4.10966115358E-06 4.26130192865E-06 4.41830806684E-06 4.58086521592E-06 4.74916537980E-06 4.92340713503E-06 5.10379585460E-06 5.29054393951E-06 5.48387105800E-06 5.68400439305E-06 5.89117889827E-06 6.10563756239E-06 6.32763168287E-06 6.55742114868E-06 6.79527473278E-06 7.04147039445E-06 7.29629559197E-06 7.56004760584E-06 7.83303387306E-06 8.11557233265E-06 8.40799178304E-06 8.71063225148E-06 9.02384537603E-06 9.34799480055E-06 9.68345658307E-06 1.00306196180E-05 1.03898860728E-05 1.07616718393E-05 1.11464070003E-05 1.15445363124E-05 1.19565197047E-05 1.23828327949E-05 1.28239674224E-05 1.32804322002E-05 1.37527530846E-05 1.42414739653E-05 1.47471572744E-05 1.52703846173E-05 1.58117574237E-05 1.63718976219E-05 1.69514483350E-05 1.75510746014E-05 1.81714641196E-05 1.88133280177E-05 1.94774016501E-05 2.01644454202E-05 2.08752456315E-05 2.16106153674E-05 2.23713954014E-05 2.31584551370E-05 2.39726935810E-05 2.48150403482E-05 2.56864567017E-05 2.65879366274E-05 2.75205079456E-05 2.84852334595E-05 2.94832121439E-05 3.05155803730E-05 3.15835131905E-05 3.26882256228E-05 3.38309740361E-05 3.50130575404E-05 3.62358194403E-05 3.75006487359E-05 3.88089816735E-05 4.01623033496E-05 4.15621493695E-05 4.30101075610E-05 4.45078197479E-05 4.60569835818E-05 4.76593544374E-05 4.93167473712E-05 5.10310391473E-05 5.28041703310E-05 5.46381474544E-05 5.65350452542E-05 5.84970089865E-05 6.05262568193E-05 6.26250823063E-05 6.47958569447E-05 6.70410328192E-05 6.93631453362E-05 7.17648160502E-05 7.42487555863E-05 7.68177666611E-05 7.94747472068E-05 8.22226936002E-05 8.50647040022E-05 8.80039818093E-05 9.10438392225E-05 9.41877009374E-05 9.74391079584E-05 1.00801721543E-04 1.04279327280E-04 1.07875839303E-04 1.11595304650E-04 1.15441907769E-04 1.19419975178E-04 1.23533980278E-04 1.27788548332E-04 1.32188461618E-04 1.36738664743E-04 1.41444270150E-04 1.46310563807E-04 1.51343011081E-04 1.56547262827E-04 1.61929161663E-04 1.67494748477E-04 1.73250269137E-04 1.79202181441E-04 1.85357162294E-04 1.91722115131E-04 1.98304177592E-04 2.05110729450E-04 2.12149400818E-04 2.19428080623E-04 2.26954925371E-04 2.34738368210E-04 2.42787128295E-04 2.51110220472E-04 2.59716965287E-04 2.68616999339E-04 2.77820285973E-04 2.87337126341E-04 2.97178170836E-04 3.07354430910E-04 3.17877291288E-04 3.28758522605E-04 3.40010294453E-04 3.51645188885E-04 3.63676214361E-04 3.76116820171E-04 3.88980911344E-04 4.02282864060E-04 4.16037541575E-04 4.30260310692E-04 4.44967058780E-04 4.60174211368E-04 4.75898750334E-04 4.92158232702E-04 5.08970810074E-04 5.26355248716E-04 5.44330950317E-04 5.62917973453E-04 5.82137055761E-04 6.02009636868E-04 6.22557882087E-04 6.43804706909E-04 6.65773802318E-04 6.88489660950E-04 7.11977604142E-04 7.36263809873E-04 7.61375341655E-04 7.87340178384E-04 8.14187245195E-04 8.41946445346E-04 8.70648693177E-04 9.00325948161E-04 9.31011250104E-04 9.62738755514E-04 9.95543775190E-04 1.02946281306E-03 1.06453360634E-03 1.10079516696E-03 1.13828782450E-03 1.17705327040E-03 1.21713460378E-03 1.25857637870E-03 1.30142465303E-03 1.34572703891E-03 1.39153275494E-03 1.43889268004E-03 1.48785940915E-03 1.53848731072E-03 1.59083258619E-03 1.64495333131E-03 1.70090959962E-03 1.75876346794E-03 1.81857910404E-03 1.88042283657E-03 1.94436322726E-03 2.01047114547E-03 2.07881984529E-03 2.14948504505E-03 2.22254500953E-03 2.29808063480E-03 2.37617553586E-03 2.45691613716E-03 2.54039176604E-03 2.62669474924E-03 2.71592051254E-03 2.80816768360E-03 2.90353819823E-03 3.00213741001E-03 3.10407420349E-03 3.20946111102E-03 3.31841443343E-03 3.43105436444E-03 3.54750511921E-03 3.66789506693E-03 3.79235686765E-03 3.92102761351E-03 4.05404897443E-03 4.19156734846E-03 4.33373401683E-03 4.48070530400E-03 4.63264274265E-03 4.78971324395E-03 4.95208927307E-03 5.11994903023E-03 5.29347663742E-03 5.47286233086E-03 5.65830265943E-03 5.85000068925E-03 6.04816621451E-03 6.25301597478E-03 6.46477387894E-03 6.68367123593E-03 6.90994699243E-03 7.14384797775E-03 7.38562915603E-03 7.63555388596E-03 7.89389418824E-03 8.16093102088E-03 8.43695456264E-03 8.72226450468E-03 9.01717035073E-03 9.32199172584E-03 9.63705869406E-03 9.96271208503E-03 1.02993038299E-02 1.06471973066E-02 1.10067676946E-02 1.13784023398E-02 1.17625011287E-02 1.21594768735E-02 1.25697557066E-02 1.29937774866E-02 1.34319962140E-02 1.38848804579E-02 1.43529137938E-02 1.48365952526E-02 1.53364397797E-02 1.58529787070E-02 1.63867602345E-02 1.69383499246E-02 1.75083312072E-02 1.80973058967E-02 1.87058947197E-02 1.93347378555E-02 1.99844954867E-02 2.06558483622E-02 2.13494983710E-02 2.20661691269E-02 2.28066065651E-02 2.35715795485E-02 2.43618804853E-02 2.51783259559E-02 2.60217573510E-02 2.68930415176E-02 2.77930714149E-02 2.87227667780E-02 2.96830747900E-02 3.06749707602E-02 3.16994588095E-02 3.27575725603E-02 3.38503758315E-02 3.49789633362E-02 3.61444613816E-02 3.73480285702E-02 3.85908564994E-02 3.98741704594E-02 4.11992301267E-02 4.25673302522E-02 4.39798013400E-02 4.54380103175E-02 4.69433611913E-02 4.84972956882E-02 5.01012938780E-02 5.17568747738E-02 5.34655969089E-02 5.52290588834E-02 5.70488998793E-02 5.89268001381E-02 6.08644813975E-02 6.28637072810E-02 6.49262836363E-02 6.70540588162E-02 6.92489238952E-02 7.15128128171E-02 7.38477024646E-02 7.62556126450E-02 7.87386059825E-02 8.12987877097E-02 8.39383053492E-02 8.66593482747E-02 8.94641471420E-02 9.23549731783E-02 9.53341373195E-02 9.84039891816E-02 1.01566915853E-01 1.04825340496E-01 1.08181720740E-01 1.11638546851E-01 1.15198339667E-01 1.18863648272E-01 1.22637047394E-01 1.26521134517E-01 1.30518526673E-01 1.34631856899E-01 1.38863770340E-01 1.43216919971E-01 1.47693961909E-01 1.52297550304E-01 1.57030331769E-01 1.61894939322E-01 1.66893985829E-01 1.72030056893E-01 1.77305703175E-01 1.82723432122E-01 1.88285699045E-01 1.93994897540E-01 1.99853349209E-01 2.05863292640E-01 2.12026871624E-01 2.18346122566E-01 2.24822961055E-01 2.31459167573E-01 2.38256372281E-01 2.45216038880E-01 2.52339447491E-01 2.59627676533E-01 2.67081583576E-01 2.74701785123E-01 2.82488635319E-01 2.90442203547E-01 2.98562250911E-01 3.06848205580E-01 3.15299136990E-01 3.23913728906E-01 3.32690251348E-01 3.41626531396E-01 3.50719922889E-01 3.59967275066E-01 3.69364900180E-01 3.78908540145E-01 3.88593332292E-01 3.98413774309E-01 4.08363688479E-01 4.18436185327E-01 4.28623626819E-01 4.38917589273E-01 4.49308826165E-01 4.59787231041E-01 4.70341800762E-01 4.80960599343E-01 4.91630722683E-01 5.02338264482E-01 5.13068283722E-01 5.23804774061E-01 5.34530635571E-01 5.45227649243E-01 5.55876454747E-01 5.66456531931E-01 5.76946186596E-01 5.87322541093E-01 5.97561530330E-01 6.07637903761E-01 6.17525233983E-01 6.27195932545E-01 6.36621273582E-01 6.45771425887E-01 6.54615494011E-01 6.63121568948E-01 6.71256788956E-01 6.78987410977E-01 6.86278893101E-01 6.93095988429E-01 6.99402850629E-01 7.05163151378E-01 7.10340209828E-01 7.14897134100E-01 7.18796974776E-01 7.22002890237E-01 7.24478323679E-01 7.26187191592E-01 7.27094083480E-01 7.27164472717E-01 7.26364938478E-01 7.24663398973E-01 7.22029356437E-01 7.18434154772E-01 7.13851251216E-01 7.08256504035E-01 7.01628478959E-01 6.93948777819E-01 6.85202393687E-01 6.75378097512E-01 6.64468861813E-01 6.52472327149E-01 6.39391316737E-01 6.25234403217E-01 6.10016529059E-01 5.93759677697E-01 5.76493585880E-01 5.58256478075E-01 5.39095790694E-01 5.19068836590E-01 4.98243338734E-01 4.76697736132E-01 4.54521136308E-01 4.31812759699E-01 4.08680697348E-01 3.85239793847E-01 3.61608487953E-01 3.37904518346E-01 3.14239570196E-01 2.90713257718E-01 2.67407395949E-01 2.44382440567E-01 2.21679455123E-01 1.99333272362E-01 1.77401994091E-01 1.55972178191E-01 1.35133643075E-01 1.14975401857E-01 9.55847728753E-02 7.70464540787E-02 5.94415753211E-02 4.28467659179E-02 2.73332752692E-02 1.29661919614E-02 -1.96196390126E-04 -1.21028758859E-02 -2.27104073169E-02 -3.19831115222E-02 -3.98932477838E-02 -4.64213925284E-02 -5.15572573846E-02 -5.53012200066E-02 -5.76667065691E-02 -5.86834037529E-02 -5.84009546400E-02 -5.68926031224E-02 -5.42580950319E-02 -5.06253131495E-02 -4.61503272555E-02 -4.10158777285E-02 -3.54283705240E-02 -2.96133976181E-02 -2.38094269814E-02 -1.82589668167E-02 -1.31961930681E-02 -8.83004608231E-03 -5.32226093084E-03 -2.76107731923E-03 -1.13400365739E-03 -3.07839203764E-04 -3.26130399288E-05 -2.23939197922E-07 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 7.47048816930E+00 -2.71001863104E+01 4.28650727892E+01 -2.62457097931E+01 -3.03953142782E+01 7.84115197013E+01 -6.39397120715E+01 1.90260641082E+01 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1 3 1 i j (l(j)) 0.00000000000E+00 Q_int 0.00000000000E+00 -9.68010433790E-18 -7.94095300659E-17 -2.74839507240E-16 -6.68125864757E-16 -1.33838601468E-15 -2.37218383969E-15 -3.86404407069E-15 -5.91699782852E-15 -8.64316109473E-15 -1.21643479732E-14 -1.66127207054E-14 -2.21314785083E-14 -2.88755874187E-14 -3.70125534423E-14 -4.67232414353E-14 -5.82027422730E-14 -7.16612910026E-14 -8.73252388197E-14 -1.05438081863E-13 -1.26261549983E-13 -1.50076758813E-13 -1.77185428643E-13 -2.07911173793E-13 -2.42600866379E-13 -2.81626078572E-13 -3.25384607673E-13 -3.74302088548E-13 -4.28833698240E-13 -4.89465957793E-13 -5.56718636617E-13 -6.31146765018E-13 -7.13342760776E-13 -8.03938676017E-13 -9.03608570928E-13 -1.01307102121E-12 -1.13309176658E-12 -1.26448650792E-12 -1.40812386117E-12 -1.56492847654E-12 -1.73588433184E-12 -1.92203820947E-12 -2.12450336689E-12 -2.34446341124E-12 -2.58317638872E-12 -2.84197910079E-12 -3.12229165897E-12 -3.42562229141E-12 -3.75357241444E-12 -4.10784198373E-12 -4.49023513961E-12 -4.90266616269E-12 -5.34716575624E-12 -5.82588767278E-12 -6.34111570341E-12 -6.89527104916E-12 -7.49092009485E-12 -8.13078260683E-12 -8.81774037736E-12 -9.55484633927E-12 -1.03453341760E-11 -1.11926284535E-11 -1.21003553016E-11 -1.30723536737E-11 -1.41126872169E-11 -1.52256567828E-11 -1.64158136145E-11 -1.76879732460E-11 -1.90472301499E-11 -2.04989731746E-11 -2.20489018125E-11 -2.37030433429E-11 -2.54677708955E-11 -2.73498224839E-11 -2.93563210602E-11 -3.14947956438E-11 -3.37732035819E-11 -3.61999540014E-11 -3.87839325139E-11 -4.15345272416E-11 -4.44616562318E-11 -4.75757963345E-11 -5.08880136188E-11 -5.44099954107E-11 -5.81540840356E-11 -6.21333123562E-11 -6.63614412001E-11 -7.08529987759E-11 -7.56233221821E-11 -8.06886011186E-11 -8.60659239171E-11 -9.17733260103E-11 -9.78298409694E-11 -1.04255554243E-10 -1.11071659738E-10 -1.18300519399E-10 -1.25965725925E-10 -1.34092168811E-10 -1.42706103870E-10 -1.51835226425E-10 -1.61508748360E-10 -1.71757479236E-10 -1.82613911680E-10 -1.94112311270E-10 -2.06288811151E-10 -2.19181511634E-10 -2.32830585028E-10 -2.47278385987E-10 -2.62569567652E-10 -2.78751203900E-10 -2.95872918000E-10 -3.13987018035E-10 -3.33148639418E-10 -3.53415894886E-10 -3.74850032357E-10 -3.97515601053E-10 -4.21480626337E-10 -4.46816793689E-10 -4.73599642325E-10 -5.01908768937E-10 -5.31828042095E-10 -5.63445827862E-10 -5.96855227190E-10 -6.32154325737E-10 -6.69446456718E-10 -7.08840477491E-10 -7.50451060581E-10 -7.94398999883E-10 -8.40811532850E-10 -8.89822679481E-10 -9.41573598979E-10 -9.96212965005E-10 -1.05389736049E-09 -1.11479169299E-09 -1.17906963173E-09 -1.24691406733E-09 -1.31851759551E-09 -1.39408302596E-09 -1.47382391768E-09 -1.55796514216E-09 -1.64674347583E-09 -1.74040822339E-09 -1.83922187340E-09 -1.94346078811E-09 -2.05341592894E-09 -2.16939361980E-09 -2.29171634997E-09 -2.42072361867E-09 -2.55677282349E-09 -2.70024019492E-09 -2.85152177933E-09 -3.01103447302E-09 -3.17921710984E-09 -3.35653160520E-09 -3.54346415945E-09 -3.74052652358E-09 -3.94825733053E-09 -4.16722349552E-09 -4.39802168887E-09 -4.64127988514E-09 -4.89765899248E-09 -5.16785456638E-09 -5.45259861210E-09 -5.75266148043E-09 -6.06885386155E-09 -6.40202888205E-09 -6.75308431048E-09 -7.12296487696E-09 -7.51266471277E-09 -7.92322991613E-09 -8.35576125062E-09 -8.81141698308E-09 -9.29141586827E-09 -9.79704028778E-09 -1.03296395511E-08 -1.08906333672E-08 -1.14815154959E-08 -1.21038575869E-08 -1.27593132185E-08 -1.34496221433E-08 -1.41766147547E-08 -1.49422167826E-08 -1.57484542326E-08 -1.65974585798E-08 -1.74914722301E-08 -1.84328542645E-08 -1.94240864786E-08 -2.04677797346E-08 -2.15666806407E-08 -2.27236785748E-08 -2.39418130710E-08 -2.52242815866E-08 -2.65744476697E-08 -2.79958495485E-08 -2.94922091624E-08 -3.10674416599E-08 -3.27256653850E-08 -3.44712123793E-08 -3.63086394247E-08 -3.82427396550E-08 -4.02785547673E-08 -4.24213878604E-08 -4.46768169365E-08 -4.70507090976E-08 -4.95492354732E-08 -5.21788869172E-08 -5.49464905130E-08 -5.78592269288E-08 -6.09246486665E-08 -6.41506992502E-08 -6.75457334029E-08 -7.11185382619E-08 -7.48783556858E-08 -7.88349057111E-08 -8.29984112148E-08 -8.73796238470E-08 -9.19898512980E-08 -9.68409859689E-08 -1.01945535117E-07 -1.07316652553E-07 -1.12968171967E-07 -1.18914641975E-07 -1.25171362958E-07 -1.31754425807E-07 -1.38680752654E-07 -1.45968139700E-07 -1.53635302248E-07 -1.61701922048E-07 -1.70188697076E-07 -1.79117393882E-07 -1.88510902616E-07 -1.98393294895E-07 -2.08789884639E-07 -2.19727292033E-07 -2.31233510784E-07 -2.43337978831E-07 -2.56071652687E-07 -2.69467085606E-07 -2.83558509768E-07 -2.98381922688E-07 -3.13975178056E-07 -3.30378081262E-07 -3.47632489814E-07 -3.65782418926E-07 -3.84874152526E-07 -4.04956359964E-07 -4.26080218730E-07 -4.48299543455E-07 -4.71670921558E-07 -4.96253855851E-07 -5.22110914468E-07 -5.49307888499E-07 -5.77913957716E-07 -6.08001864816E-07 -6.39648098601E-07 -6.72933086579E-07 -7.07941397441E-07 -7.44761953941E-07 -7.83488256709E-07 -8.24218619548E-07 -8.67056416811E-07 -9.12110343487E-07 -9.59494688621E-07 -1.00932962279E-06 -1.06174150031E-06 -1.11686317697E-06 -1.17483434409E-06 -1.23580187966E-06 -1.29992021759E-06 -1.36735173581E-06 -1.43826716437E-06 -1.51284601443E-06 -1.59127702925E-06 -1.67375865839E-06 -1.76049955611E-06 -1.85171910550E-06 -1.94764796933E-06 -2.04852866928E-06 -2.15461619481E-06 -2.26617864328E-06 -2.38349789290E-06 -2.50687031015E-06 -2.63660749358E-06 -2.77303705559E-06 -2.91650344441E-06 -3.06736880823E-06 -3.22601390349E-06 -3.39283904994E-06 -3.56826513442E-06 -3.75273466631E-06 -3.94671288691E-06 -4.15068893572E-06 -4.36517707653E-06 -4.59071798630E-06 -4.82788011001E-06 -5.07726108504E-06 -5.33948923846E-06 -5.61522516095E-06 -5.90516336149E-06 -6.21003400660E-06 -6.53060474883E-06 -6.86768264876E-06 -7.22211619543E-06 -7.59479743023E-06 -7.98666417951E-06 -8.39870240144E-06 -8.83194865302E-06 -9.28749268334E-06 -9.76648015945E-06 -1.02701155318E-05 -1.07996650464E-05 -1.13564599105E-05 -1.19418996209E-05 -1.25574554622E-05 -1.32046741836E-05 -1.38851818641E-05 -1.46006879753E-05 -1.53529896514E-05 -1.61439761779E-05 -1.69756337095E-05 -1.78500502292E-05 -1.87694207601E-05 -1.97360528445E-05 -2.07523723015E-05 -2.18209292798E-05 -2.29444046185E-05 -2.41256165330E-05 -2.53675276426E-05 -2.66732523553E-05 -2.80460646306E-05 -2.94894061377E-05 -3.10068948296E-05 -3.26023339543E-05 -3.42797215257E-05 -3.60432602763E-05 -3.78973681178E-05 -3.98466891339E-05 -4.18961051330E-05 -4.40507477890E-05 -4.63160113999E-05 -4.86975662958E-05 -5.12013729282E-05 -5.38336966766E-05 -5.66011234070E-05 -5.95105758215E-05 -6.25693306382E-05 -6.57850366434E-05 -6.91657336609E-05 -7.27198724829E-05 -7.64563358130E-05 -8.03844602701E-05 -8.45140595088E-05 -8.88554485106E-05 -9.34194691049E-05 -9.82175167831E-05 -1.03261568869E-04 -1.08564214113E-04 -1.14138683784E-04 -1.19998884334E-04 -1.26159431704E-04 -1.32635687374E-04 -1.39443796222E-04 -1.46600726295E-04 -1.54124310584E-04 -1.62033290905E-04 -1.70347363983E-04 -1.79087229862E-04 -1.88274642736E-04 -1.97932464348E-04 -2.08084720058E-04 -2.18756657727E-04 -2.29974809552E-04 -2.41767056998E-04 -2.54162698977E-04 -2.67192523440E-04 -2.80888882537E-04 -2.95285771540E-04 -3.10418911688E-04 -3.26325837167E-04 -3.43045986419E-04 -3.60620797985E-04 -3.79093811109E-04 -3.98510771339E-04 -4.18919741349E-04 -4.40371217256E-04 -4.62918250681E-04 -4.86616576840E-04 -5.11524748950E-04 -5.37704279245E-04 -5.65219786944E-04 -5.94139153469E-04 -6.24533685277E-04 -6.56478284672E-04 -6.90051628956E-04 -7.25336358327E-04 -7.62419272936E-04 -8.01391539520E-04 -8.42348908070E-04 -8.85391939001E-04 -9.30626241305E-04 -9.78162722206E-04 -1.02811784883E-03 -1.08061392248E-03 -1.13577936601E-03 -1.19374902504E-03 -1.25466448346E-03 -1.31867439405E-03 -1.38593482471E-03 -1.45660962122E-03 -1.53087078703E-03 -1.60889888101E-03 -1.69088343395E-03 -1.77702338443E-03 -1.86752753522E-03 -1.96261503086E-03 -2.06251585740E-03 -2.16747136531E-03 -2.27773481650E-03 -2.39357195648E-03 -2.51526161267E-03 -2.64309632012E-03 -2.77738297552E-03 -2.91844352094E-03 -3.06661565831E-03 -3.22225359600E-03 -3.38572882874E-03 -3.55743095229E-03 -3.73776851407E-03 -3.92716990140E-03 -4.12608426860E-03 -4.33498250454E-03 -4.55435824220E-03 -4.78472891179E-03 -5.02663683901E-03 -5.28065039025E-03 -5.54736516632E-03 -5.82740524646E-03 -6.12142448453E-03 -6.43010785910E-03 -6.75417287935E-03 -7.09437104871E-03 -7.45148938816E-03 -7.82635202117E-03 -8.21982182230E-03 -8.63280213157E-03 -9.06623853652E-03 -9.52112072430E-03 -9.99848440570E-03 -1.04994133135E-02 -1.10250412770E-02 -1.15765543754E-02 -1.21551931720E-02 -1.27622550311E-02 -1.33990965203E-02 -1.40671359008E-02 -1.47678557069E-02 -1.55028054175E-02 -1.62736042222E-02 -1.70819438834E-02 -1.79295916972E-02 -1.88183935549E-02 -1.97502771071E-02 -2.07272550327E-02 -2.17514284143E-02 -2.28249902225E-02 -2.39502289093E-02 -2.51295321143E-02 -2.63653904827E-02 -2.76604015977E-02 -2.90172740279E-02 -3.04388314893E-02 -3.19280171229E-02 -3.34878978868E-02 -3.51216690619E-02 -3.68326588701E-02 -3.86243332011E-02 -4.05003004456E-02 -4.24643164288E-02 -4.45202894395E-02 -4.66722853458E-02 -4.89245327875E-02 -5.12814284347E-02 -5.37475422954E-02 -5.63276230562E-02 -5.90266034326E-02 -6.18496055040E-02 -6.48019460017E-02 -6.78891415116E-02 -7.11169135492E-02 -7.44911934540E-02 -7.80181270408E-02 -8.17040789388E-02 -8.55556365312E-02 -8.95796133995E-02 -9.37830521585E-02 -9.81732265502E-02 -1.02757642644E-01 -1.07544038970E-01 -1.12540385387E-01 -1.17754880448E-01 -1.23195947017E-01 -1.28872225833E-01 -1.34792566688E-01 -1.40966016848E-01 -1.47401806302E-01 -1.54109329357E-01 -1.61098122086E-01 -1.68377835031E-01 -1.75958200555E-01 -1.83848994160E-01 -1.92059989030E-01 -2.00600903013E-01 -2.09481337219E-01 -2.18710705343E-01 -2.28298152828E-01 -2.38252464931E-01 -2.48581962788E-01 -2.59294386595E-01 -2.70396765071E-01 -2.81895270471E-01 -2.93795058587E-01 -3.06100093323E-01 -3.18812955754E-01 -3.31934637865E-01 -3.45464321639E-01 -3.59399144641E-01 -3.73733953902E-01 -3.88461050638E-01 -4.03569929161E-01 -4.19047014366E-01 -4.34875403192E-01 -4.51034616682E-01 -4.67500370458E-01 -4.84244372735E-01 -5.01234160213E-01 -5.18432983312E-01 -5.35799753128E-01 -5.53289063052E-01 -5.70851297997E-01 -5.88432843507E-01 -6.05976405332E-01 -6.23421447092E-01 -6.40704749195E-01 -6.57761085683E-01 -6.74524007109E-01 -6.90926706317E-01 -7.06902930135E-01 -7.22387883303E-01 -7.37319051718E-01 -7.51636850874E-01 -7.65284983315E-01 -7.78210367892E-01 -7.90362486577E-01 -8.01691985584E-01 -8.12148372348E-01 -8.21676676116E-01 -8.30212996775E-01 -8.37678965951E-01 -8.43975298375E-01 -8.48974834109E-01 -8.52515773117E-01 -8.54396187393E-01 -8.54371352313E-01 -8.52155930713E-01 -8.47433488827E-01 -8.39876063252E-01 -8.29176253649E-01 -8.15093116464E-01 -7.97510217554E-01 -7.76498363616E-01 -7.52364904272E-01 -7.25653236259E-01 -6.97025963557E-01 -6.66960160605E-01 -6.35666044508E-01 -6.03333459054E-01 -5.70162117055E-01 -5.36360093856E-01 -5.02141714217E-01 -4.67725198192E-01 -4.33330121450E-01 -3.99174701462E-01 -3.65473005763E-01 -3.32432134801E-01 -3.00249532842E-01 -2.69110531390E-01 -2.39186323962E-01 -2.10632481638E-01 -1.83588147540E-01 -1.58175860193E-01 -1.34501877080E-01 -1.12656617693E-01 -9.27147937783E-02 -7.47347207861E-02 -5.87565283660E-02 -4.47992158857E-02 -3.28568626412E-02 -2.28944665371E-02 -1.48439710085E-02 -8.60093573741E-03 -4.02226301202E-03 -9.25435818390E-04 9.10012407344E-04 1.73768339718E-03 1.83461921497E-03 1.48498523734E-03 9.55769492193E-04 4.64745477758E-04 1.44862355469E-04 1.72534189213E-05 1.06489865751E-07 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 -7.37954482160E+00 2.15170527553E+01 -1.01345657971E+02 4.54818066670E+02 -1.12544193208E+03 1.49807015533E+03 -1.01940009376E+03 2.78926099334E+02 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1 4 1 i j (l(j)) 0.00000000000E+00 Q_int 0.00000000000E+00 1.90030205750E-17 1.55888912042E-16 5.39537656679E-16 1.31159841995E-15 2.62738665681E-15 4.65683599462E-15 7.58550800828E-15 1.16156631735E-14 1.69673964634E-14 2.38798412428E-14 3.26124453134E-14 4.34463231729E-14 5.66856887716E-14 7.26593732834E-14 9.17224326519E-14 1.14257849930E-13 1.40678337707E-13 1.71428246196E-13 2.06985582860E-13 2.47864149778E-13 2.94615805274E-13 3.47832856689E-13 4.08150591551E-13 4.76249954790E-13 5.52860380029E-13 6.38762783464E-13 7.34792729240E-13 8.41843775772E-13 9.60871012905E-13 1.09289480038E-12 1.23900471864E-12 1.40036374348E-12 1.57821265693E-12 1.77387470709E-12 1.98876053048E-12 2.22437335134E-12 2.48231447268E-12 2.76428907519E-12 3.07211234041E-12 3.40771591593E-12 3.77315474108E-12 4.17061425252E-12 4.60241799026E-12 5.07103562585E-12 5.57909143523E-12 6.12937324047E-12 6.72484184535E-12 7.36864099159E-12 8.06410786340E-12 8.81478417009E-12 9.62442783740E-12 1.04970253405E-11 1.14368047125E-11 1.24482492655E-11 1.35361120612E-11 1.47054311714E-11 1.59615457716E-11 1.73101131104E-11 1.87571264023E-11 2.03089336940E-11 2.19722577532E-11 2.37542170380E-11 2.56623478011E-11 2.77046273907E-11 2.98894988117E-11 3.22258966132E-11 3.47232741732E-11 3.73916324544E-11 4.02415503091E-11 4.32842164151E-11 4.65314629284E-11 4.99958009444E-11 5.36904578627E-11 5.76294167552E-11 6.18274578453E-11 6.63002022067E-11 7.10641578020E-11 7.61367679816E-11 8.15364625744E-11 8.72827117058E-11 9.33960824866E-11 9.98982987248E-11 1.06812303817E-10 1.14162326991E-10 1.21973953067E-10 1.30274195935E-10 1.39091575930E-10 1.48456201319E-10 1.58399854113E-10 1.68956080424E-10 1.80160285623E-10 1.92049834522E-10 2.04664156878E-10 2.18044858464E-10 2.32235838020E-10 2.47283410391E-10 2.63236436157E-10 2.80146458117E-10 2.98067844972E-10 3.17057942589E-10 3.37177233230E-10 3.58489503188E-10 3.81062019232E-10 4.04965714358E-10 4.30275383301E-10 4.57069888338E-10 4.85432375906E-10 5.15450504605E-10 5.47216685177E-10 5.80828333081E-10 6.16388134332E-10 6.54004325274E-10 6.93790987040E-10 7.35868355431E-10 7.80363147046E-10 8.27408902487E-10 8.77146347536E-10 9.29723773240E-10 9.85297435878E-10 1.04403197785E-09 1.10610087059E-09 1.17168688058E-09 1.24098255977E-09 1.31419076161E-09 1.39152518398E-09 1.47321094051E-09 1.55948516167E-09 1.65059762732E-09 1.74681143207E-09 1.84840368555E-09 1.95566624898E-09 2.06890651028E-09 2.18844819944E-09 2.31463224644E-09 2.44781768379E-09 2.58838259607E-09 2.73672511890E-09 2.89326448984E-09 3.05844215396E-09 3.23272292699E-09 3.41659621876E-09 3.61057732044E-09 3.81520875849E-09 4.03106171907E-09 4.25873754637E-09 4.49886931879E-09 4.75212350692E-09 5.01920171757E-09 5.30084252839E-09 5.59782341753E-09 5.91096279360E-09 6.24112213070E-09 6.58920821433E-09 6.95617550365E-09 7.34302861620E-09 7.75082494141E-09 8.18067738953E-09 8.63375728295E-09 9.11129739727E-09 9.61459515993E-09 1.01450160144E-08 1.07039969585E-08 1.12930502661E-08 1.19137674009E-08 1.25678231337E-08 1.32569798712E-08 1.39830922106E-08 1.47481117280E-08 1.55540920154E-08 1.64031939782E-08 1.72976914061E-08 1.82399768321E-08 1.92325676949E-08 2.02781128185E-08 2.13793992279E-08 2.25393593165E-08 2.37610783832E-08 2.50478025595E-08 2.64029471458E-08 2.78301053779E-08 2.93330576463E-08 3.09157811917E-08 3.25824603005E-08 3.43374970270E-08 3.61855224684E-08 3.81314086219E-08 4.01802808541E-08 4.23375310125E-08 4.46088312143E-08 4.70001483464E-08 4.95177593125E-08 5.21682670672E-08 5.49586174766E-08 5.78961170481E-08 6.09884515744E-08 6.42437057385E-08 6.76703837294E-08 7.12774309197E-08 7.50742566611E-08 7.90707582542E-08 8.32773461531E-08 8.77049704692E-08 9.23651488396E-08 9.72699957314E-08 1.02432253256E-07 1.07865323569E-07 1.13583302939E-07 1.19601017575E-07 1.25934061289E-07 1.32598835109E-07 1.39612588921E-07 1.46993465265E-07 1.54760545375E-07 1.62933897598E-07 1.71534628298E-07 1.80584935386E-07 1.90108164595E-07 2.00128868665E-07 2.10672869558E-07 2.21767323886E-07 2.33440791701E-07 2.45723308817E-07 2.58646462866E-07 2.72243473252E-07 2.86549275227E-07 3.01600608288E-07 3.17436109119E-07 3.34096409312E-07 3.51624238115E-07 3.70064530462E-07 3.89464540559E-07 4.09873961304E-07 4.31345049853E-07 4.53932759639E-07 4.77694879173E-07 5.02692177985E-07 5.28988560060E-07 5.56651225167E-07 5.85750838473E-07 6.16361708874E-07 6.48561976490E-07 6.82433809798E-07 7.18063612887E-07 7.55542243365E-07 7.94965241461E-07 8.36433070892E-07 8.80051372113E-07 9.25931228561E-07 9.74189446590E-07 1.02494884977E-06 1.07833858830E-06 1.13449446435E-06 1.19355927402E-06 1.25568316697E-06 1.32102402443E-06 1.38974785668E-06 1.46202922086E-06 1.53805166033E-06 1.61800816651E-06 1.70210166444E-06 1.79054552330E-06 1.88356409307E-06 1.98139326884E-06 2.08428108394E-06 2.19248833364E-06 2.30628923077E-06 2.42597209505E-06 2.55184007770E-06 2.68421192333E-06 2.82342277085E-06 2.96982499549E-06 3.12378909406E-06 3.28570461548E-06 3.45598113925E-06 3.63504930393E-06 3.82336188842E-06 4.02139494876E-06 4.22964901312E-06 4.44865033815E-06 4.67895222970E-06 4.92113643127E-06 5.17581458366E-06 5.44362975940E-06 5.72525807592E-06 6.02141039130E-06 6.33283408702E-06 6.66031494202E-06 7.00467910285E-06 7.36679515472E-06 7.74757629869E-06 8.14798264045E-06 8.56902359623E-06 9.01176042213E-06 9.47730887283E-06 9.96684199660E-06 1.04815930734E-05 1.10228587033E-05 1.15920020536E-05 1.21904562709E-05 1.28197280699E-05 1.34814015035E-05 1.41771419280E-05 1.49087001697E-05 1.56779169056E-05 1.64867272680E-05 1.73371656844E-05 1.82313709652E-05 1.91715916518E-05 2.01601916380E-05 2.11996560787E-05 2.22925976011E-05 2.34417628328E-05 2.46500392647E-05 2.59204624628E-05 2.72562236509E-05 2.86606776782E-05 3.01373513960E-05 3.16899524609E-05 3.33223785881E-05 3.50387272772E-05 3.68433060339E-05 3.87406431142E-05 4.07354988165E-05 4.28328773495E-05 4.50380393057E-05 4.73565147714E-05 4.97941171047E-05 5.23569574155E-05 5.50514597845E-05 5.78843772566E-05 6.08628086494E-05 6.39942162178E-05 6.72864442180E-05 7.07477384155E-05 7.43867665875E-05 7.82126400663E-05 8.22349363799E-05 8.64637230425E-05 9.09095825546E-05 9.55836386735E-05 1.00497584017E-04 1.05663709071E-04 1.11094932665E-04 1.16804833999E-04 1.22807686289E-04 1.29118492126E-04 1.35753020615E-04 1.42727846407E-04 1.50060390700E-04 1.57768964317E-04 1.65872812964E-04 1.74392164769E-04 1.83348280238E-04 1.92763504715E-04 2.02661323508E-04 2.13066419779E-04 2.24004735367E-04 2.35503534667E-04 2.47591471729E-04 2.60298660730E-04 2.73656749994E-04 2.87698999729E-04 3.02460363667E-04 3.17977574803E-04 3.34289235431E-04 3.51435911686E-04 3.69460232829E-04 3.88406995486E-04 4.08323273099E-04 4.29258530847E-04 4.51264746285E-04 4.74396536005E-04 4.98711288591E-04 5.24269304194E-04 5.51133941025E-04 5.79371769122E-04 6.09052731734E-04 6.40250314682E-04 6.73041724097E-04 7.07508072920E-04 7.43734576595E-04 7.81810758390E-04 8.21830664800E-04 8.63893091514E-04 9.08101820454E-04 9.54565868386E-04 1.00339974767E-03 1.05472373972E-03 1.10866418170E-03 1.16535376722E-03 1.22493186147E-03 1.28754483172E-03 1.35334639356E-03 1.42249797395E-03 1.49516909160E-03 1.57153775553E-03 1.65179088268E-03 1.73612473535E-03 1.82474537939E-03 1.91786916407E-03 2.01572322451E-03 2.11854600776E-03 2.22658782347E-03 2.34011142021E-03 2.45939258860E-03 2.58472079230E-03 2.71639982806E-03 2.85474851606E-03 3.00010142170E-03 3.15280961025E-03 3.31324143547E-03 3.48178336380E-03 3.65884083524E-03 3.84483916257E-03 4.04022447014E-03 4.24546467391E-03 4.46105050405E-03 4.68749657180E-03 4.92534248195E-03 5.17515399272E-03 5.43752422444E-03 5.71307491861E-03 6.00245774916E-03 6.30635568712E-03 6.62548442060E-03 6.96059383143E-03 7.31246953005E-03 7.68193445006E-03 8.06985050395E-03 8.47712030121E-03 8.90468893020E-03 9.35354580494E-03 9.82472657771E-03 1.03193151186E-02 1.08384455624E-02 1.13833044241E-02 1.19551327816E-02 1.25552285288E-02 1.31849486949E-02 1.38457118329E-02 1.45390004738E-02 1.52663636477E-02 1.60294194668E-02 1.68298577710E-02 1.76694428317E-02 1.85500161106E-02 1.94734990684E-02 2.04418960207E-02 2.14572970319E-02 2.25218808432E-02 2.36379178247E-02 2.48077729434E-02 2.60339087367E-02 2.73188882789E-02 2.86653781277E-02 3.00761512358E-02 3.15540898103E-02 3.31021881009E-02 3.47235550961E-02 3.64214171033E-02 3.81991201872E-02 4.00601324376E-02 4.20080460342E-02 4.40465790737E-02 4.61795771204E-02 4.84110144383E-02 5.07449948580E-02 5.31857522276E-02 5.57376503937E-02 5.84051826509E-02 6.11929705964E-02 6.41057623183E-02 6.71484298418E-02 7.03259657525E-02 7.36434789068E-02 7.71061891377E-02 8.07194208523E-02 8.44885954160E-02 8.84192222075E-02 9.25168882241E-02 9.67872461086E-02 1.01236000465E-01 1.05868892320E-01 1.10691681584E-01 1.15710127358E-01 1.20929965933E-01 1.26356886314E-01 1.31996503108E-01 1.37854326611E-01 1.43935729924E-01 1.50245912941E-01 1.56789863039E-01 1.63572312330E-01 1.70597691327E-01 1.77870078892E-01 1.85393148364E-01 1.93170109777E-01 2.01203648108E-01 2.09495857531E-01 2.18048171689E-01 2.26861290059E-01 2.35935100503E-01 2.45268598223E-01 2.54859801327E-01 2.64705663387E-01 2.74801983371E-01 2.85143313499E-01 2.95722865639E-01 3.06532416993E-01 3.17562215938E-01 3.28800889036E-01 3.40235350315E-01 3.51850714117E-01 3.63630212885E-01 3.75555121425E-01 3.87604689267E-01 3.99756082849E-01 4.11984339315E-01 4.24262333739E-01 4.36560761585E-01 4.48848138108E-01 4.61090816286E-01 4.73253024600E-01 4.85296925690E-01 4.97182696409E-01 5.08868629282E-01 5.20311254603E-01 5.31465481574E-01 5.42284755869E-01 5.52721229835E-01 5.62725940262E-01 5.72248987288E-01 5.81239706528E-01 5.89646825174E-01 5.97418591467E-01 6.04502866000E-01 6.10847162685E-01 6.16398627373E-01 6.21103943122E-01 6.24909153470E-01 6.27759399023E-01 6.29598568726E-01 6.30368875766E-01 6.30010379602E-01 6.28460490553E-01 6.25653511927E-01 6.21520297053E-01 6.15988124324E-01 6.08980921880E-01 6.00420003230E-01 5.90225503366E-01 5.78318727965E-01 5.64625640292E-01 5.49081703762E-01 5.31638262422E-01 5.12270563696E-01 4.90987392286E-01 4.67842072477E-01 4.42944291202E-01 4.16471779654E-01 3.88680360700E-01 3.59910235670E-01 3.30585693833E-01 3.01204791594E-01 2.72315176188E-01 2.44472497351E-01 2.18179392503E-01 1.93806874699E-01 1.71507730138E-01 1.51145767076E-01 1.32289314138E-01 1.14358053102E-01 9.70211419696E-02 8.03065155339E-02 6.42832282779E-02 4.90174497460E-02 3.45714680575E-02 2.10028675218E-02 8.36371681742E-03 -3.30018225527E-03 -1.39499571334E-02 -2.35541730176E-02 -3.20891476793E-02 -3.95390116228E-02 -4.58954964976E-02 -5.11574562674E-02 -5.53302095649E-02 -5.84248694964E-02 -6.04579240763E-02 -6.14513847150E-02 -6.14337838417E-02 -6.04421654880E-02 -5.85249368956E-02 -5.57451861276E-02 -5.21838403077E-02 -4.79420590684E-02 -4.31423909841E-02 -3.79285155471E-02 -3.24635240624E-02 -2.69267154160E-02 -2.15086266750E-02 -1.64037414544E-02 -1.18000357927E-02 -7.86451447817E-03 -4.72427629822E-03 -2.44376474702E-03 -1.00116962677E-03 -2.71179411293E-04 -2.86712959661E-05 -2.10458129356E-07 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1.44867903469E+01 -4.84363030292E+01 -2.48229101341E+01 5.25038584613E+02 -1.49245667925E+03 2.04044262865E+03 -1.39569943065E+03 3.81802593746E+02 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1 5 2 i j (l(j)) 0.00000000000E+00 Q_int 0.00000000000E+00 -8.96013415174E-24 -1.48242010155E-22 -7.76092242487E-22 -2.53679578267E-21 -6.40594168204E-21 -1.37405964468E-20 -2.63348322082E-20 -4.64810939488E-20 -7.70379299348E-20 -1.21504652519E-19 -1.84103542840E-19 -2.69870262876E-19 -3.84753192149E-19 -5.35722464282E-19 -7.30889541080E-19 -9.79638228943E-19 -1.29276811483E-18 -1.68265147679E-18 -2.16340480797E-18 -2.75107618308E-18 -3.46384979347E-18 -4.32226908115E-18 -5.34948001467E-18 -6.57149617004E-18 -8.01748741037E-18 -9.72009409685E-18 -1.17157689143E-17 -1.40451485554E-17 -1.67534576820E-17 -1.98909477668E-17 -2.35133736203E-17 -2.76825106230E-17 -3.24667159130E-17 -3.79415370288E-17 -4.41903717721E-17 -5.13051833451E-17 -5.93872751206E-17 -6.85481297360E-17 -7.89103175578E-17 -9.06084799407E-17 -1.03790393119E-16 -1.18618119004E-16 -1.35269249630E-16 -1.53938252504E-16 -1.74837924654E-16 -1.98200963745E-16 -2.24281665273E-16 -2.53357755503E-16 -2.85732370546E-16 -3.21736192737E-16 -3.61729756301E-16 -4.06105935196E-16 -4.55292626958E-16 -5.09755647401E-16 -5.70001852125E-16 -6.36582501954E-16 -7.10096890697E-16 -7.91196254947E-16 -8.80587987125E-16 -9.79040174497E-16 -1.08738648856E-15 -1.20653145099E-15 -1.33745610427E-15 -1.48122411710E-15 -1.63898835699E-15 -1.81199796475E-15 -2.00160596802E-15 -2.20927747389E-15 -2.43659848338E-15 -2.68528537375E-15 -2.95719509787E-15 -3.25433615358E-15 -3.57888037966E-15 -3.93317563909E-15 -4.31975945496E-15 -4.74137366859E-15 -5.20098019510E-15 -5.70177795636E-15 -6.24722107762E-15 -6.84103844004E-15 -7.48725468785E-15 -8.19021279638E-15 -8.95459831427E-15 -9.78546540185E-15 -1.06882647960E-14 -1.16688738412E-14 -1.27336287371E-14 -1.38893591622E-14 -1.51434254465E-14 -1.65037584774E-14 -1.79789025351E-14 -1.95780612705E-14 -2.13111470519E-14 -2.31888339219E-14 -2.52226144263E-14 -2.74248605930E-14 -2.98088893581E-14 -3.23890327605E-14 -3.51807132461E-14 -3.82005244485E-14 -4.14663178389E-14 -4.49972956654E-14 -4.88141106318E-14 -5.29389727991E-14 -5.73957642239E-14 -6.22101618890E-14 -6.74097695165E-14 -7.30242588975E-14 -7.90855214178E-14 -8.56278305053E-14 -9.26880157779E-14 -1.00305649724E-13 -1.08523247807E-13 -1.17386482953E-13 -1.26944415430E-13 -1.37249739237E-13 -1.48359046144E-13 -1.60333108660E-13 -1.73237183264E-13 -1.87141335328E-13 -2.02120787276E-13 -2.18256291628E-13 -2.35634530684E-13 -2.54348544728E-13 -2.74498190785E-13 -2.96190634076E-13 -3.19540874490E-13 -3.44672310535E-13 -3.71717343437E-13 -4.00818024188E-13 -4.32126746601E-13 -4.65806989600E-13 -5.02034112222E-13 -5.40996205044E-13 -5.82895002004E-13 -6.27946856877E-13 -6.76383788952E-13 -7.28454602771E-13 -7.84426087155E-13 -8.44584299081E-13 -9.09235938370E-13 -9.78709819578E-13 -1.05335844791E-12 -1.13355970644E-12 -1.21971866253E-12 -1.31226950168E-12 -1.41167759787E-12 -1.51844172991E-12 -1.63309645402E-12 -1.75621464364E-12 -1.88841020817E-12 -2.03034100310E-12 -2.18271194507E-12 -2.34627834608E-12 -2.52184948229E-12 -2.71029241374E-12 -2.91253607257E-12 -3.12957563861E-12 -3.36247722225E-12 -3.61238287622E-12 -3.88051595929E-12 -4.16818687623E-12 -4.47679922072E-12 -4.80785634896E-12 -5.16296841427E-12 -5.54385989486E-12 -5.95237764907E-12 -6.39049953503E-12 -6.86034363396E-12 -7.36417811945E-12 -7.90443181744E-12 -8.48370550544E-12 -9.10478400211E-12 -9.77064910276E-12 -1.04844934192E-11 -1.12497351874E-11 -1.20700341102E-11 -1.29493083070E-11 -1.38917524475E-11 -1.49018571530E-11 -1.59844297513E-11 -1.71446164815E-11 -1.83879262489E-11 -1.97202560374E-11 -2.11479180947E-11 -2.26776690155E-11 -2.43167408509E-11 -2.60728743896E-11 -2.79543547574E-11 -2.99700494997E-11 -3.21294493173E-11 -3.44427116411E-11 -3.69207072427E-11 -3.95750700910E-11 -4.24182506821E-11 -4.54635730819E-11 -4.87252959404E-11 -5.22186777527E-11 -5.59600466629E-11 -5.99668751244E-11 -6.42578597558E-11 -6.88530067505E-11 -7.37737232289E-11 -7.90429149418E-11 -8.46850907683E-11 -9.07264744790E-11 -9.71951242679E-11 -1.04121060592E-10 -1.11536402897E-10 -1.19475515840E-10 -1.27975165672E-10 -1.37074687491E-10 -1.46816164099E-10 -1.57244617292E-10 -1.68408212427E-10 -1.80358477197E-10 -1.93150535590E-10 -2.06843358090E-10 -2.21500029248E-10 -2.37188033815E-10 -2.53979562737E-10 -2.71951840376E-10 -2.91187474439E-10 -3.11774830177E-10 -3.33808430540E-10 -3.57389384086E-10 -3.82625842563E-10 -4.09633490225E-10 -4.38536067072E-10 -4.69465928362E-10 -5.02564642915E-10 -5.37983632886E-10 -5.75884857881E-10 -6.16441546484E-10 -6.59838978476E-10 -7.06275321254E-10 -7.55962524204E-10 -8.09127275032E-10 -8.66012022349E-10 -9.26876069078E-10 -9.91996741605E-10 -1.06167063989E-09 -1.13621497418E-09 -1.21596899420E-09 -1.30129551746E-09 -1.39258256318E-09 -1.49024509950E-09 -1.59472691156E-09 -1.70650259890E-09 -1.82607971112E-09 -1.95400103137E-09 -2.09084701785E-09 -2.23723841429E-09 -2.39383904102E-09 -2.56135877929E-09 -2.74055676190E-09 -2.93224478472E-09 -3.13729095419E-09 -3.35662358707E-09 -3.59123538005E-09 -3.84218786773E-09 -4.11061618893E-09 -4.39773418263E-09 -4.70483983641E-09 -5.03332111162E-09 -5.38466217131E-09 -5.76045003896E-09 -6.16238171747E-09 -6.59227180042E-09 -7.05206060959E-09 -7.54382289496E-09 -8.06977713625E-09 -8.63229548736E-09 -9.23391440828E-09 -9.87734603185E-09 -1.05654903161E-08 -1.13014480369E-08 -1.20885346775E-08 -1.29302952795E-08 -1.38305203189E-08 -1.47932626796E-08 -1.58228558000E-08 -1.69239330730E-08 -1.81014485870E-08 -1.93606992998E-08 -2.07073487439E-08 -2.21474523703E-08 -2.36874846430E-08 -2.53343680048E-08 -2.70955038446E-08 -2.89788056034E-08 -3.09927341674E-08 -3.31463357055E-08 -3.54492821206E-08 -3.79119142945E-08 -4.05452883197E-08 -4.33612249239E-08 -4.63723623078E-08 -4.95922126325E-08 -5.30352224068E-08 -5.67168370450E-08 -6.06535698827E-08 -6.48630759579E-08 -6.93642308869E-08 -7.41772151859E-08 -7.93236044149E-08 -8.48264655454E-08 -9.07104599812E-08 -9.70019536918E-08 -1.03729134949E-07 -1.10922140191E-07 -1.18613188578E-07 -1.26836725830E-07 -1.35629578004E-07 -1.45031115873E-07 -1.55083430666E-07 -1.65831521924E-07 -1.77323498335E-07 -1.89610792422E-07 -2.02748390052E-07 -2.16795075787E-07 -2.31813695163E-07 -2.47871435077E-07 -2.65040123519E-07 -2.83396549990E-07 -3.03022808030E-07 -3.24006661392E-07 -3.46441935471E-07 -3.70428935754E-07 -3.96074895139E-07 -4.23494452120E-07 -4.52810161971E-07 -4.84153043195E-07 -5.17663161677E-07 -5.53490255146E-07 -5.91794400710E-07 -6.32746728460E-07 -6.76530184288E-07 -7.23340345346E-07 -7.73386291751E-07 -8.26891538424E-07 -8.84095031216E-07 -9.45252211746E-07 -1.01063615568E-06 -1.08053878954E-06 -1.15527219145E-06 -1.23516998154E-06 -1.32058880836E-06 -1.41190993768E-06 -1.50954095098E-06 -1.61391756098E-06 -1.72550555245E-06 -1.84480285684E-06 -1.97234176991E-06 -2.10869132239E-06 -2.25445981399E-06 -2.41029752222E-06 -2.57689959794E-06 -2.75500916053E-06 -2.94542060647E-06 -3.14898314601E-06 -3.36660458363E-06 -3.59925535912E-06 -3.84797286716E-06 -4.11386607469E-06 -4.39812045648E-06 -4.70200327084E-06 -5.02686919895E-06 -5.37416637271E-06 -5.74544281802E-06 -6.14235334193E-06 -6.56666689432E-06 -7.02027443671E-06 -7.50519735310E-06 -8.02359644015E-06 -8.57778151644E-06 -9.17022169360E-06 -9.80355635459E-06 -1.04806068879E-05 -1.12043892294E-05 -1.19781272677E-05 -1.28052671724E-05 -1.36894927072E-05 -1.46347415983E-05 -1.56452230274E-05 -1.67254363292E-05 -1.78801909736E-05 -1.91146279227E-05 -2.04342424557E-05 -2.18449085628E-05 -2.33529050153E-05 -2.49649432267E-05 -2.66881970276E-05 -2.85303344851E-05 -3.04995519066E-05 -3.26046101774E-05 -3.48548735906E-05 -3.72603513413E-05 -3.98317418648E-05 -4.25804802134E-05 -4.55187886797E-05 -4.86597308856E-05 -5.20172695740E-05 -5.56063283542E-05 -5.94428576694E-05 -6.35439052724E-05 -6.79276915151E-05 -7.26136897774E-05 -7.76227123822E-05 -8.29770023674E-05 -8.87003315093E-05 -9.48181050165E-05 -1.01357473345E-04 -1.08347451611E-04 -1.15819047106E-04 -1.23805395461E-04 -1.32341906038E-04 -1.41466417146E-04 -1.51219361763E-04 -1.61643944423E-04 -1.72786330040E-04 -1.84695845425E-04 -1.97425194349E-04 -2.11030687027E-04 -2.25572484964E-04 -2.41114862163E-04 -2.57726483748E-04 -2.75480703125E-04 -2.94455878863E-04 -3.14735712567E-04 -3.36409609044E-04 -3.59573060196E-04 -3.84328054109E-04 -4.10783510905E-04 -4.39055747009E-04 -4.69268969580E-04 -5.01555802926E-04 -5.36057848823E-04 -5.72926282779E-04 -6.12322488335E-04 -6.54418731634E-04 -6.99398878569E-04 -7.47459156925E-04 -7.98808966023E-04 -8.53671736487E-04 -9.12285842832E-04 -9.74905571657E-04 -1.04180214835E-03 -1.11326482520E-03 -1.18960203406E-03 -1.27114260643E-03 -1.35823706429E-03 -1.45125898470E-03 -1.55060644129E-03 -1.65670352583E-03 -1.77000195282E-03 -1.89098275014E-03 -2.02015803859E-03 -2.15807290286E-03 -2.30530735643E-03 -2.46247840242E-03 -2.63024219226E-03 -2.80929628316E-03 -3.00038199544E-03 -3.20428686953E-03 -3.42184722198E-03 -3.65395079894E-03 -3.90153952426E-03 -4.16561233845E-03 -4.44722812308E-03 -4.74750870370E-03 -5.06764192245E-03 -5.40888476960E-03 -5.77256656068E-03 -6.16009214328E-03 -6.57294511487E-03 -7.01269102913E-03 -7.48098056526E-03 -7.97955263009E-03 -8.51023735868E-03 -9.07495897401E-03 -9.67573846100E-03 -1.03146960043E-02 -1.09940531330E-02 -1.17161345082E-02 -1.24833692833E-02 -1.32982919572E-02 -1.41635426344E-02 -1.50818665974E-02 -1.60561130851E-02 -1.70892331672E-02 -1.81842765906E-02 -1.93443874679E-02 -2.05727986686E-02 -2.18728247649E-02 -2.32478533784E-02 -2.47013347657E-02 -2.62367694791E-02 -2.78576939329E-02 -2.95676637083E-02 -3.13702344332E-02 -3.32689400774E-02 -3.52672685187E-02 -3.73686342509E-02 -3.95763481265E-02 -4.18935840618E-02 -4.43233426644E-02 -4.68684117969E-02 -4.95313241446E-02 -5.23143119247E-02 -5.52192589553E-02 -5.82476503938E-02 -6.14005205590E-02 -6.46783993680E-02 -6.80812580455E-02 -7.16084548992E-02 -7.52586820998E-02 -7.90299145495E-02 -8.29193620657E-02 -8.69234262443E-02 -9.10376634815E-02 -9.52567557233E-02 -9.95744905570E-02 -1.03983752248E-01 -1.08476525231E-01 -1.13043911389E-01 -1.17676162119E-01 -1.22362725752E-01 -1.27092310221E-01 -1.31852960071E-01 -1.36632145775E-01 -1.41416862064E-01 -1.46193730317E-01 -1.50949098267E-01 -1.55669128158E-01 -1.60339862187E-01 -1.64947251706E-01 -1.69477134246E-01 -1.73915140268E-01 -1.78246509880E-01 -1.82455798864E-01 -1.86526453804E-01 -1.90440238350E-01 -1.94176497422E-01 -1.97711254215E-01 -2.01016147035E-01 -2.04057230228E-01 -2.06793686468E-01 -2.09176527198E-01 -2.11147394196E-01 -2.12637617675E-01 -2.13567733453E-01 -2.13847710496E-01 -2.13378185181E-01 -2.12053031708E-01 -2.09763607162E-01 -2.06404978142E-01 -2.01884341913E-01 -1.96131671898E-01 -1.89112314386E-01 -1.80840809983E-01 -1.71394586047E-01 -1.60925363384E-01 -1.49665186119E-01 -1.37923049931E-01 -1.26067458060E-01 -1.14490426802E-01 -1.03550473115E-01 -9.34976170320E-02 -8.43951735184E-02 -7.60755220083E-02 -6.82071178099E-02 -6.05759474005E-02 -5.32048523830E-02 -4.61461059411E-02 -3.94498131072E-02 -3.31630027113E-02 -2.73287078130E-02 -2.19849863925E-02 -1.71639173173E-02 -1.28905663700E-02 -9.18198033750E-03 -6.04622773507E-03 -3.48158699550E-03 -1.47594671102E-03 -6.57636043884E-06 9.59626390582E-04 1.46524305446E-03 1.56075445891E-03 1.30226693385E-03 7.48769402663E-04 -4.07642109323E-05 -1.00993544667E-03 -2.10674462818E-03 -3.28437607637E-03 -4.50097297889E-03 -5.71862465717E-03 -6.90198433160E-03 -8.01687208280E-03 -9.02913319539E-03 -9.90384259674E-03 -1.06048966200E-02 -1.10950385265E-02 -1.13364952450E-02 -1.12925691247E-02 -1.09307263317E-02 -1.02279179995E-02 -9.17903522235E-03 -7.80954544897E-03 -6.19347320372E-03 -4.47586586038E-03 -2.85783353506E-03 -1.52852638495E-03 -6.17227444715E-04 -1.47476702695E-04 -8.93130061215E-06 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 -6.23994211027E+00 5.34754941721E-01 1.89878231112E+02 -9.31026872249E+02 2.14267175223E+03 -2.65707651926E+03 1.70634674309E+03 -4.45418516586E+02 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1 6 2 i j (l(j)) 0.00000000000E+00 Q_int 0.00000000000E+00 1.46387486131E-23 2.42192525670E-22 1.26795191299E-21 4.14452675782E-21 1.04657997667E-20 2.24488979491E-20 4.30249125678E-20 7.59391587314E-20 1.25861830967E-19 1.98509981385E-19 3.00781822792E-19 4.40904440700E-19 6.28596086086E-19 8.75244315461E-19 1.19410134673E-18 1.60049810919E-18 2.11207858404E-18 2.74905615932E-18 3.53449385964E-18 4.49461045896E-18 5.65911464260E-18 7.06156955581E-18 8.73979025909E-18 1.07362768082E-17 1.30986858884E-17 1.58803441615E-17 1.91408067281E-17 2.29464643720E-17 2.73712035382E-17 3.24971232962E-17 3.84153138735E-17 4.52267016909E-17 5.30429662108E-17 6.19875343158E-17 7.21966583701E-17 8.38205845845E-17 9.70248188086E-17 1.11991497413E-16 1.28920871506E-16 1.48032913346E-16 1.69569054495E-16 1.93794065941E-16 2.20998091239E-16 2.51498844490E-16 2.85643985917E-16 3.23813688694E-16 3.66423411766E-16 4.13926894436E-16 4.66819389711E-16 5.25641154635E-16 5.90981217218E-16 6.63481440973E-16 7.43840909690E-16 8.32820656694E-16 9.31248764658E-16 1.04002586394E-15 1.16013105946E-15 1.29262831843E-15 1.43867335348E-15 1.59952103828E-15 1.77653339572E-15 1.97118820120E-15 2.18508824707E-15 2.41997131747E-15 2.67772092644E-15 2.96037787584E-15 3.27015269420E-15 3.60943902147E-15 3.98082800981E-15 4.38712381545E-15 4.83136026208E-15 5.31681876219E-15 5.84704758888E-15 6.42588259740E-15 7.05746950288E-15 7.74628782844E-15 8.49717664589E-15 9.31536224029E-15 1.02064878390E-14 1.11766455557E-14 1.22324107116E-14 1.33808787056E-14 1.46297046210E-14 1.59871457658E-14 1.74621073607E-14 1.90641916028E-14 2.08037503506E-14 2.26919416908E-14 2.47407906699E-14 2.69632544907E-14 2.93732924955E-14 3.19859412836E-14 3.48173953311E-14 3.78850935109E-14 4.12078119381E-14 4.48057635937E-14 4.87007052168E-14 5.29160519859E-14 5.74770005476E-14 6.24106609939E-14 6.77461984275E-14 7.35149848027E-14 7.97507617777E-14 8.64898153655E-14 9.37711632270E-14 1.01636755510E-13 1.10131690203E-13 1.19304444030E-13 1.29207120013E-13 1.39895712870E-13 1.51430393533E-13 1.63875814140E-13 1.77301434957E-13 1.91781874803E-13 2.07397286618E-13 2.24233760003E-13 2.42383752602E-13 2.61946552407E-13 2.83028773157E-13 3.05744885199E-13 3.30217784289E-13 3.56579401063E-13 3.84971354020E-13 4.15545649119E-13 4.48465429269E-13 4.83905777258E-13 5.22054575879E-13 5.63113429307E-13 6.07298650035E-13 6.54842316015E-13 7.05993402943E-13 7.61018996985E-13 8.20205593629E-13 8.83860488711E-13 9.52313268123E-13 1.02591740315E-12 1.10505195884E-12 1.19012342342E-12 1.28156766724E-12 1.37985204026E-12 1.48547761806E-12 1.59898160649E-12 1.72093991638E-12 1.85196992009E-12 1.99273340270E-12 2.14393972157E-12 2.30634918870E-12 2.48077669180E-12 2.66809557052E-12 2.86924176589E-12 3.08521826209E-12 3.31709984099E-12 3.56603817137E-12 3.83326725630E-12 4.12010926370E-12 4.42798076684E-12 4.75839942368E-12 5.11299112536E-12 5.49349764713E-12 5.90178483634E-12 6.33985137542E-12 6.80983815985E-12 7.31403833403E-12 7.85490803120E-12 8.43507786629E-12 9.05736523457E-12 9.72478747206E-12 1.04405759381E-11 1.12081910840E-11 1.20313385774E-11 1.29139865545E-11 1.38603840809E-11 1.48750809027E-11 1.59629485804E-11 1.71292031000E-11 1.83794290656E-11 1.97196055821E-11 2.11561339478E-11 2.26958672810E-11 2.43461422161E-11 2.61148128138E-11 2.80102868380E-11 3.00415645659E-11 3.22182803063E-11 3.45507468146E-11 3.70500028068E-11 3.97278637869E-11 4.25969764197E-11 4.56708766931E-11 4.89640521361E-11 5.24920083723E-11 5.62713403109E-11 6.03198082979E-11 6.46564195717E-11 6.93015153913E-11 7.42768642317E-11 7.96057614679E-11 8.53131359974E-11 9.14256642834E-11 9.79718923349E-11 1.04982366172E-10 1.12489771369E-10 1.20529082302E-10 1.29137721775E-10 1.38355731750E-10 1.48225955941E-10 1.58794235103E-10 1.70109615900E-10 1.82224574278E-10 1.95195254366E-10 2.09081723978E-10 2.23948247855E-10 2.39863579894E-10 2.56901275669E-10 2.75140026652E-10 2.94664017648E-10 3.15563309033E-10 3.37934245536E-10 3.61879893391E-10 3.87510507823E-10 4.14944032982E-10 4.44306636557E-10 4.75733281492E-10 5.09368337350E-10 5.45366234089E-10 5.83892161185E-10 6.25122815233E-10 6.69247199393E-10 7.16467478261E-10 7.66999892015E-10 8.21075733929E-10 8.78942395642E-10 9.40864484878E-10 1.00712502063E-09 1.07802671117E-09 1.15389332060E-09 1.23507113010E-09 1.32193050042E-09 1.41486754260E-09 1.51430590442E-09 1.62069868056E-09 1.73453045516E-09 1.85631948567E-09 1.98662003807E-09 2.12602488372E-09 2.27516796909E-09 2.43472727035E-09 2.60542784553E-09 2.78804509804E-09 2.98340826601E-09 3.19240415315E-09 3.41598111790E-09 3.65515333854E-09 3.91100537353E-09 4.18469703739E-09 4.47746861391E-09 4.79064643016E-09 5.12564881597E-09 5.48399247587E-09 5.86729930170E-09 6.27730365649E-09 6.71586016216E-09 7.18495202591E-09 7.68669994236E-09 8.22337161146E-09 8.79739191454E-09 9.41135379407E-09 1.00680298857E-08 1.07703849546E-08 1.15215891918E-08 1.23250324294E-08 1.31843393390E-08 1.41033856809E-08 1.50863156758E-08 1.61375605781E-08 1.72618585329E-08 1.84642758053E-08 1.97502294771E-08 2.11255117122E-08 2.25963156990E-08 2.41692633855E-08 2.58514351316E-08 2.76504014094E-08 2.95742566954E-08 3.16316557039E-08 3.38318521233E-08 3.61847400305E-08 3.87008981652E-08 4.13916372638E-08 4.42690506634E-08 4.73460684016E-08 5.06365150539E-08 5.41551715664E-08 5.79178413596E-08 6.19414209992E-08 6.62439757477E-08 7.08448203350E-08 7.57646053076E-08 8.10254093423E-08 8.66508379354E-08 9.26661289081E-08 9.90982651989E-08 1.05976095445E-07 1.13330462891E-07 1.21194343202E-07 1.29602991790E-07 1.38594101320E-07 1.48207970085E-07 1.58487682013E-07 1.69479299104E-07 1.81232067153E-07 1.93798635677E-07 2.07235293033E-07 2.21602217763E-07 2.36963747295E-07 2.53388665203E-07 2.70950508292E-07 2.89727894889E-07 3.09804875797E-07 3.31271309483E-07 3.54223263165E-07 3.78763441591E-07 4.05001645417E-07 4.33055261236E-07 4.63049785431E-07 4.95119384190E-07 5.29407492187E-07 5.66067452592E-07 6.05263201254E-07 6.47169998120E-07 6.91975209151E-07 7.39879142198E-07 7.91095940592E-07 8.45854538411E-07 9.04399681693E-07 9.66993020129E-07 1.03391427413E-06 1.10546248243E-06 1.18195733585E-06 1.26374060305E-06 1.35117765477E-06 1.44465909326E-06 1.54460249415E-06 1.65145426856E-06 1.76569165380E-06 1.88782484138E-06 2.01839925195E-06 2.15799796729E-06 2.30724433010E-06 2.46680472327E-06 2.63739154096E-06 2.81976636476E-06 3.01474335905E-06 3.22319290076E-06 3.44604545953E-06 3.68429574586E-06 3.93900714535E-06 4.21131645916E-06 4.50243897151E-06 4.81367386704E-06 5.14641002189E-06 5.50213219465E-06 5.88242764440E-06 6.28899320555E-06 6.72364285095E-06 7.18831577692E-06 7.68508504617E-06 8.21616682722E-06 8.78393027139E-06 9.39090807130E-06 1.00398077480E-05 1.07335237169E-05 1.14751501863E-05 1.22679949456E-05 1.31155941052E-05 1.40217278533E-05 1.49904372991E-05 1.60260424789E-05 1.71331616034E-05 1.83167316333E-05 1.95820302732E-05 2.09346994837E-05 2.23807706132E-05 2.39266912644E-05 2.55793540120E-05 2.73461271009E-05 2.92348872604E-05 3.12540547803E-05 3.34126310045E-05 3.57202384078E-05 3.81871634346E-05 4.08244022882E-05 4.36437098741E-05 4.66576521136E-05 4.98796618592E-05 5.33240986589E-05 5.70063126332E-05 6.09427127469E-05 6.51508397769E-05 6.96494442965E-05 7.44585700214E-05 7.95996428815E-05 8.50955662120E-05 9.09708224793E-05 9.72515819892E-05 1.03965819052E-04 1.11143436114E-04 1.18816396389E-04 1.27018865587E-04 1.35787363324E-04 1.45160924908E-04 1.55181274169E-04 1.65893008099E-04 1.77343794090E-04 1.89584580619E-04 2.02669822288E-04 2.16657720170E-04 2.31610478495E-04 2.47594578763E-04 2.64681072440E-04 2.82945893477E-04 3.02470191953E-04 3.23340690248E-04 3.45650063220E-04 3.69497343948E-04 3.94988356735E-04 4.22236179111E-04 4.51361634736E-04 4.82493819170E-04 5.15770660634E-04 5.51339517975E-04 5.89357818186E-04 6.29993735984E-04 6.73426918051E-04 7.19849254710E-04 7.69465701950E-04 8.22495156869E-04 8.79171389738E-04 9.39744036074E-04 1.00447965226E-03 1.07366283840E-03 1.14759743230E-03 1.22660777852E-03 1.31104007678E-03 1.40126381401E-03 1.49767328448E-03 1.60068920269E-03 1.71076041377E-03 1.82836570617E-03 1.95401573169E-03 2.08825503779E-03 2.23166421723E-03 2.38486218015E-03 2.54850855348E-03 2.72330621276E-03 2.91000395095E-03 3.10939928891E-03 3.32234143177E-03 3.54973437494E-03 3.79254016328E-03 4.05178230604E-03 4.32854934955E-03 4.62399860885E-03 4.93936005808E-03 5.27594037835E-03 5.63512716037E-03 6.01839325701E-03 6.42730127931E-03 6.86350822683E-03 7.32877024053E-03 7.82494746347E-03 8.35400899075E-03 8.91803788649E-03 9.51923624085E-03 1.01599302352E-02 1.08425751776E-02 1.15697604657E-02 1.23442144243E-02 1.31688089610E-02 1.40465639715E-02 1.49806514190E-02 1.59743990002E-02 1.70312933018E-02 1.81549823365E-02 1.93492773376E-02 2.06181536760E-02 2.19657507496E-02 2.33963706795E-02 2.49144756332E-02 2.65246835768E-02 2.82317622426E-02 3.00406210833E-02 3.19563009657E-02 3.39839613425E-02 3.61288646274E-02 3.83963574834E-02 4.07918487271E-02 4.33207835434E-02 4.59886137017E-02 4.88007634674E-02 5.17625909125E-02 5.48793443423E-02 5.81561135833E-02 6.15977759130E-02 6.52089364593E-02 6.89938629608E-02 7.29564148603E-02 7.70999667954E-02 8.14273266724E-02 8.59406486441E-02 9.06413414724E-02 9.55299729436E-02 1.00606171209E-01 1.05868524155E-01 1.11314478164E-01 1.16940237890E-01 1.22740668959E-01 1.28709205798E-01 1.34837767082E-01 1.41116681528E-01 1.47534627050E-01 1.54078586395E-01 1.60733822531E-01 1.67483876991E-01 1.74310594218E-01 1.81194174577E-01 1.88113258098E-01 1.95045040067E-01 2.01965418381E-01 2.08849170867E-01 2.15670158678E-01 2.22401549272E-01 2.29016049342E-01 2.35486134436E-01 2.41784257866E-01 2.47883017035E-01 2.53755250559E-01 2.59374034897E-01 2.64712544940E-01 2.69743739649E-01 2.74439832153E-01 2.78771504475E-01 2.82706831461E-01 2.86209887779E-01 2.89239027583E-01 2.91744850280E-01 2.93667899443E-01 2.94936187047E-01 2.95462692875E-01 2.95143059778E-01 2.93853788493E-01 2.91451327953E-01 2.87772552376E-01 2.82637204532E-01 2.75852949179E-01 2.67223698224E-01 2.56561807036E-01 2.43704557012E-01 2.28534980454E-01 2.11006490133E-01 1.91169887623E-01 1.69200095540E-01 1.45418386085E-01 1.20304048175E-01 9.44876073242E-02 6.87164486924E-02 4.37840728804E-02 2.04181562249E-02 -8.66633681147E-04 -1.99221095849E-02 -3.70534522954E-02 -5.28881306357E-02 -6.78246859896E-02 -8.17992873931E-02 -9.46926369291E-02 -1.06392203205E-01 -1.16794317550E-01 -1.25806256364E-01 -1.33348378774E-01 -1.39356244170E-01 -1.43782684618E-01 -1.46599720252E-01 -1.47800257238E-01 -1.47399407494E-01 -1.45435327203E-01 -1.41969379254E-01 -1.37085522129E-01 -1.30888800465E-01 -1.23503004282E-01 -1.15067639741E-01 -1.05734604964E-01 -9.56650121140E-02 -8.50266710138E-02 -7.39925266454E-02 -6.27401176983E-02 -5.14517574233E-02 -4.03149676949E-02 -2.95226012896E-02 -1.92721918592E-02 -9.76413828667E-03 -1.19835313139E-03 6.23113643903E-03 1.23443536462E-02 1.69872089175E-02 2.00478851289E-02 2.14781611011E-02 2.13187469817E-02 1.97250035038E-02 1.69844876128E-02 1.35093745347E-02 9.77665019857E-03 6.25027306889E-03 3.34678988215E-03 1.35282127913E-03 3.23524727173E-04 1.95953661377E-05 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1.01945955680E+01 3.95299393792E+00 -3.78045392445E+02 1.82803297055E+03 -4.19819632676E+03 5.20384314394E+03 -3.34161123341E+03 8.72298121044E+02 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2 2 0 i j (l(j)) 1.44265379511E-03 Q_int 0.00000000000E+00 8.38543064550E-13 3.41078043403E-12 7.80413523454E-12 1.41094754674E-11 2.24212388685E-11 3.28375621357E-11 4.54604146750E-11 6.03957370204E-11 7.77535840884E-11 9.76482734345E-11 1.20198538681E-10 1.45527688299E-10 1.73763769919E-10 2.05039740372E-10 2.39493641654E-10 2.77268783004E-10 3.18513929332E-10 3.63383496191E-10 4.12037751525E-10 4.64643024434E-10 5.21371921186E-10 5.82403548728E-10 6.47923745949E-10 7.18125322984E-10 7.93208308785E-10 8.73380207304E-10 9.58856262535E-10 1.04985973274E-09 1.14662217415E-09 1.24938373456E-09 1.35839345697E-09 1.47390959378E-09 1.59619993193E-09 1.72554212908E-09 1.86222406165E-09 2.00654418466E-09 2.15881190415E-09 2.31934796234E-09 2.48848483621E-09 2.66656714970E-09 2.85395210019E-09 3.05100989970E-09 3.25812423126E-09 3.47569272098E-09 3.70412742650E-09 3.94385534210E-09 4.19531892129E-09 4.45897661747E-09 4.73530344293E-09 5.02479154742E-09 5.32795081636E-09 5.64530948973E-09 5.97741480219E-09 6.32483364527E-09 6.68815325220E-09 7.06798190648E-09 7.46494967437E-09 7.87970916309E-09 8.31293630460E-09 8.76533116638E-09 9.23761879028E-09 9.73055005977E-09 1.02449025973E-08 1.07814816919E-08 1.13411212597E-08 1.19246848356E-08 1.25330666008E-08 1.31671924441E-08 1.38280210608E-08 1.45165450877E-08 1.52337922789E-08 1.59808267198E-08 1.67587500845E-08 1.75687029350E-08 1.84118660654E-08 1.92894618921E-08 2.02027558912E-08 2.11530580856E-08 2.21417245827E-08 2.31701591645E-08 2.42398149323E-08 2.53521960075E-08 2.65088592910E-08 2.77114162819E-08 2.89615349593E-08 3.02609417272E-08 3.16114234272E-08 3.30148294191E-08 3.44730737326E-08 3.59881372930E-08 3.75620702221E-08 3.91969942185E-08 4.08951050187E-08 4.26586749422E-08 4.44900555231E-08 4.63916802333E-08 4.83660672952E-08 5.04158225946E-08 5.25436426893E-08 5.47523179224E-08 5.70447356411E-08 5.94238835256E-08 6.18928530311E-08 6.44548429470E-08 6.71131630790E-08 6.98712380539E-08 7.27326112573E-08 7.57009489024E-08 7.87800442405E-08 8.19738219124E-08 8.52863424494E-08 8.87218069281E-08 9.22845617817E-08 9.59791037776E-08 9.98100851639E-08 1.03782318989E-07 1.07900784606E-07 1.12170633363E-07 1.16597194484E-07 1.21185981156E-07 1.25942696819E-07 1.30873241671E-07 1.35983719395E-07 1.41280444116E-07 1.46769947592E-07 1.52458986651E-07 1.58354550885E-07 1.64463870595E-07 1.70794425020E-07 1.77353950840E-07 1.84150450961E-07 1.91192203612E-07 1.98487771741E-07 2.06046012740E-07 2.13876088488E-07 2.21987475750E-07 2.30389976917E-07 2.39093731123E-07 2.48109225726E-07 2.57447308196E-07 2.67119198391E-07 2.77136501264E-07 2.87511219989E-07 2.98255769548E-07 3.09382990765E-07 3.20906164830E-07 3.32839028305E-07 3.45195788647E-07 3.57991140260E-07 3.71240281089E-07 3.84958929774E-07 3.99163343399E-07 4.13870335828E-07 4.29097296683E-07 4.44862210943E-07 4.61183679236E-07 4.78080938797E-07 4.95573885151E-07 5.13683094527E-07 5.32429847041E-07 5.51836150657E-07 5.71924765958E-07 5.92719231783E-07 6.14243891704E-07 6.36523921419E-07 6.59585357072E-07 6.83455124543E-07 7.08161069705E-07 7.33731989752E-07 7.60197665540E-07 7.87588895080E-07 8.15937528113E-07 8.45276501902E-07 8.75639878230E-07 9.07062881630E-07 9.39581938929E-07 9.73234720160E-07 1.00806018080E-06 1.04409860552E-06 1.08139165334E-06 1.11998240438E-06 1.15991540817E-06 1.20123673360E-06 1.24399402056E-06 1.28823653334E-06 1.33401521584E-06 1.38138274870E-06 1.43039360822E-06 1.48110412752E-06 1.53357255948E-06 1.58785914211E-06 1.64402616592E-06 1.70213804368E-06 1.76226138251E-06 1.82446505844E-06 1.88882029346E-06 1.95540073525E-06 2.02428253951E-06 2.09554445519E-06 2.16926791256E-06 2.24553711425E-06 2.32443912941E-06 2.40606399103E-06 2.49050479660E-06 2.57785781215E-06 2.66822257984E-06 2.76170202917E-06 2.85840259197E-06 2.95843432131E-06 3.06191101441E-06 3.16895033973E-06 3.27967396840E-06 3.39420770994E-06 3.51268165293E-06 3.63523030997E-06 3.76199276803E-06 3.89311284352E-06 4.02873924281E-06 4.16902572817E-06 4.31413128923E-06 4.46422032043E-06 4.61946280425E-06 4.78003450080E-06 4.94611714386E-06 5.11789864340E-06 5.29557329511E-06 5.47934199695E-06 5.66941247303E-06 5.86599950506E-06 6.06932517175E-06 6.27961909612E-06 6.49711870133E-06 6.72206947512E-06 6.95472524316E-06 7.19534845165E-06 7.44421045967E-06 7.70159184112E-06 7.96778269704E-06 8.24308297848E-06 8.52780282027E-06 8.82226288614E-06 9.12679472531E-06 9.44174114148E-06 9.76745657386E-06 1.01043074915E-05 1.04526728006E-05 1.08129442658E-05 1.11855269456E-05 1.15708396427E-05 1.19693153691E-05 1.23814018271E-05 1.28075619072E-05 1.32482742016E-05 1.37040335359E-05 1.41753515185E-05 1.46627571086E-05 1.51667972031E-05 1.56880372437E-05 1.62270618440E-05 1.67844754386E-05 1.73609029525E-05 1.79569904951E-05 1.85734060759E-05 1.92108403448E-05 1.98700073581E-05 2.05516453693E-05 2.12565176467E-05 2.19854133191E-05 2.27391482491E-05 2.35185659367E-05 2.43245384524E-05 2.51579674022E-05 2.60197849253E-05 2.69109547242E-05 2.78324731306E-05 2.87853702065E-05 2.97707108821E-05 3.07895961326E-05 3.18431641938E-05 3.29325918183E-05 3.40590955748E-05 3.52239331894E-05 3.64284049337E-05 3.76738550573E-05 3.89616732702E-05 4.02932962730E-05 4.16702093394E-05 4.30939479515E-05 4.45660994890E-05 4.60883049752E-05 4.76622608817E-05 4.92897209920E-05 5.09724983281E-05 5.27124671422E-05 5.45115649718E-05 5.63717947662E-05 5.82952270816E-05 6.02840023499E-05 6.23403332229E-05 6.44665069940E-05 6.66648880998E-05 6.89379207050E-05 7.12881313723E-05 7.37181318210E-05 7.62306217772E-05 7.88283919149E-05 8.15143268996E-05 8.42914085265E-05 8.71627189646E-05 9.01314441082E-05 9.32008770345E-05 9.63744215803E-05 9.96555960307E-05 1.03048036931E-04 1.06555503021E-04 1.10181879301E-04 1.13931181225E-04 1.17807559037E-04 1.21815302242E-04 1.25958844225E-04 1.30242767016E-04 1.34671806218E-04 1.39250856081E-04 1.43984974747E-04 1.48879389667E-04 1.53939503180E-04 1.59170898285E-04 1.64579344583E-04 1.70170804421E-04 1.75951439219E-04 1.81927616010E-04 1.88105914180E-04 1.94493132418E-04 2.01096295893E-04 2.07922663648E-04 2.14979736231E-04 2.22275263561E-04 2.29817253040E-04 2.37613977919E-04 2.45673985912E-04 2.54006108090E-04 2.62619468040E-04 2.71523491297E-04 2.80727915078E-04 2.90242798300E-04 3.00078531903E-04 3.10245849485E-04 3.20755838251E-04 3.31619950287E-04 3.42850014180E-04 3.54458246955E-04 3.66457266389E-04 3.78860103663E-04 3.91680216386E-04 4.04931501993E-04 4.18628311532E-04 4.32785463820E-04 4.47418260019E-04 4.62542498605E-04 4.78174490759E-04 4.94331076164E-04 5.11029639246E-04 5.28288125846E-04 5.46125060324E-04 5.64559563132E-04 5.83611368824E-04 6.03300844532E-04 6.23649008914E-04 6.44677551587E-04 6.66408852981E-04 6.88866004762E-04 7.12072830658E-04 7.36053907795E-04 7.60834588564E-04 7.86441022902E-04 8.12900181119E-04 8.40239877186E-04 8.68488792510E-04 8.97676500173E-04 9.27833489686E-04 9.58991192155E-04 9.91182005956E-04 1.02443932280E-03 1.05879755429E-03 1.09429215884E-03 1.13095966902E-03 1.16883771929E-03 1.20796507408E-03 1.24838165613E-03 1.29012857528E-03 1.33324815734E-03 1.37778397333E-03 1.42378086885E-03 1.47128499352E-03 1.52034383061E-03 1.57100622665E-03 1.62332242098E-03 1.67734407521E-03 1.73312430251E-03 1.79071769658E-03 1.85018036038E-03 1.91156993420E-03 1.97494562339E-03 2.04036822523E-03 2.10790015509E-03 2.17760547154E-03 2.24954990052E-03 2.32380085802E-03 2.40042747151E-03 2.47950059966E-03 2.56109285022E-03 2.64527859580E-03 2.73213398750E-03 2.82173696577E-03 2.91416726866E-03 3.00950643676E-03 3.10783781481E-03 3.20924654951E-03 3.31381958309E-03 3.42164564246E-03 3.53281522330E-03 3.64742056885E-03 3.76555564262E-03 3.88731609495E-03 4.01279922231E-03 4.14210391943E-03 4.27533062297E-03 4.41258124650E-03 4.55395910598E-03 4.69956883494E-03 4.84951628856E-03 5.00390843595E-03 5.16285323948E-03 5.32645952048E-03 5.49483681005E-03 5.66809518424E-03 5.84634508200E-03 6.02969710516E-03 6.21826179912E-03 6.41214941234E-03 6.61146963434E-03 6.81633130952E-03 7.02684212621E-03 7.24310827861E-03 7.46523410064E-03 7.69332166903E-03 7.92747037473E-03 8.16777645979E-03 8.41433251847E-03 8.66722695953E-03 8.92654342865E-03 9.19236018752E-03 9.46474944783E-03 9.74377665780E-03 1.00294997382E-02 1.03219682654E-02 1.06212225993E-02 1.09272929523E-02 1.12401983973E-02 1.15599458118E-02 1.18865287543E-02 1.22199262713E-02 1.25601016311E-02 1.29070009810E-02 1.32605519266E-02 1.36206620275E-02 1.39872172097E-02 1.43600800895E-02 1.47390882067E-02 1.51240521655E-02 1.55147536797E-02 1.59109435202E-02 1.63123393634E-02 1.67186235389E-02 1.71294406742E-02 1.75443952375E-02 1.79630489768E-02 1.83849182565E-02 1.88094712925E-02 1.92361252873E-02 1.96642434681E-02 2.00931320307E-02 2.05220369964E-02 2.09501409835E-02 2.13765599061E-02 2.18003396045E-02 2.22204524200E-02 2.26357937266E-02 2.30451784320E-02 2.34473374679E-02 2.38409142840E-02 2.42244613732E-02 2.45964368459E-02 2.49552010880E-02 2.52990135274E-02 2.56260295495E-02 2.59342975949E-02 2.62217564878E-02 2.64862330376E-02 2.67254399715E-02 2.69369742493E-02 2.71183158307E-02 2.72668269585E-02 2.73797520373E-02 2.74542181871E-02 2.74872365604E-02 2.74757045238E-02 2.74164088014E-02 2.73060296965E-02 2.71411465101E-02 2.69182442856E-02 2.66337220157E-02 2.62839024591E-02 2.58650437218E-02 2.53733527649E-02 2.48050010184E-02 2.41561422732E-02 2.34229330497E-02 2.26015556352E-02 2.16882439958E-02 2.06793127722E-02 1.95711895721E-02 1.83604507730E-02 1.70438610511E-02 1.56184168408E-02 1.40813939284E-02 1.24303993602E-02 1.06634278319E-02 8.77892268729E-03 6.77584162392E-03 4.65372713898E-03 2.41278169187E-03 5.39474654359E-05 -2.42100949295E-03 -5.00941110918E-03 -7.70757561062E-03 -1.05107230569E-02 -1.34128790209E-02 -1.64067776366E-02 -1.94837655623E-02 -2.26337087743E-02 -2.58449045405E-02 -2.91040013933E-02 -3.23959304579E-02 -3.57038520535E-02 -3.90091220772E-02 -4.22912832778E-02 -4.55280870691E-02 -4.86955520156E-02 -5.17680654090E-02 -5.47185344248E-02 -5.75185929950E-02 -6.01388697193E-02 -6.25493205256E-02 -6.47196273470E-02 -6.66196604013E-02 -6.82199966703E-02 -6.94924804993E-02 -7.04108039904E-02 -7.09510748611E-02 -7.10923283815E-02 -7.08169287444E-02 -7.01107957007E-02 -6.89633881072E-02 -6.73673827012E-02 -6.53180129881E-02 -6.28120938266E-02 -5.98468733568E-02 -5.64190570454E-02 -5.25246864748E-02 -4.81610962445E-02 -4.33330157763E-02 -3.80644308720E-02 -3.23991482546E-02 -2.63890176775E-02 -2.00925529078E-02 -1.35747533637E-02 -6.90688447259E-03 -1.66176460387E-04 6.56457223601E-03 1.31975125649E-02 1.96404249553E-02 2.57976259673E-02 3.15711917926E-02 3.68626153958E-02 4.15750244036E-02 4.56160732421E-02 4.89015442436E-02 5.13595651451E-02 5.29351323623E-02 5.35944425606E-02 5.33283685648E-02 5.21545121693E-02 5.01174947262E-02 4.72876766661E-02 4.37588482282E-02 3.96457414935E-02 3.50819060389E-02 3.02181353617E-02 2.52208190999E-02 2.02692546811E-02 1.55504343587E-02 1.12500439415E-02 7.53842713035E-03 4.55119491055E-03 2.36518957293E-03 9.73185321809E-04 2.64735892262E-04 2.80859923418E-05 -1.89786830364E-08 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 6.99774956033E-01 -5.55625762123E+00 1.51282281556E+01 -2.61668570172E+01 3.78302900177E+01 -4.16303754362E+01 2.71368039019E+01 -7.45449902209E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2 3 1 i j (l(j)) 0.00000000000E+00 Q_int 0.00000000000E+00 1.16552598464E-17 9.56124722305E-17 3.30918527436E-16 8.04452131091E-16 1.61147403285E-15 2.85621085162E-15 4.65247440826E-15 7.12431858104E-15 1.04067358094E-14 1.46463954869E-14 2.00024266075E-14 2.66472471564E-14 3.47674428727E-14 4.45646981553E-14 5.62567820303E-14 7.00785922596E-14 8.62832608363E-14 1.05143324285E-13 1.26951962377E-13 1.52024309052E-13 1.80698839561E-13 2.13338838044E-13 2.50333949989E-13 2.92101824267E-13 3.39089849673E-13 3.91776991177E-13 4.50675731372E-13 5.16334122894E-13 5.89337957898E-13 6.70313060995E-13 7.59927712423E-13 8.58895208537E-13 9.67976567142E-13 1.08798338555E-12 1.21978085964E-12 1.36429097281E-12 1.52249586381E-12 1.69544138342E-12 1.88424085004E-12 2.09007901506E-12 2.31421624927E-12 2.55799296231E-12 2.82283426778E-12 3.11025490717E-12 3.42186444662E-12 3.75937276117E-12 4.12459582202E-12 4.51946180299E-12 4.94601752339E-12 5.40643524540E-12 5.90301984477E-12 6.43821637513E-12 7.01461804664E-12 7.63497464151E-12 8.30220138935E-12 9.01938832728E-12 9.78981017037E-12 1.06169367198E-11 1.15044438372E-11 1.24562250159E-11 1.34764035798E-11 1.45693455442E-11 1.57396731734E-11 1.69922792723E-11 1.83323422500E-11 1.97653419982E-11 2.12970766257E-11 2.29336800953E-11 2.46816408111E-11 2.65478212058E-11 2.85394783814E-11 3.06642858587E-11 3.29303564942E-11 3.53462666270E-11 3.79210815183E-11 4.06643821547E-11 4.35862934844E-11 4.66975141640E-11 5.00093478939E-11 5.35337364273E-11 5.72832943395E-11 6.12713456512E-11 6.55119624024E-11 7.00200052808E-11 7.48111664102E-11 7.99020144155E-11 8.53100418811E-11 9.10537153291E-11 9.71525278505E-11 1.03627054527E-10 1.10499010791E-10 1.17791313875E-10 1.25528147519E-10 1.33735030092E-10 1.42438886331E-10 1.51668122854E-10 1.61452707677E-10 1.71824253921E-10 1.82816107937E-10 1.94463442083E-10 2.06803352387E-10 2.19874961359E-10 2.33719526220E-10 2.48380552820E-10 2.63903915560E-10 2.80337983617E-10 2.97733753802E-10 3.16144990407E-10 3.35628372387E-10 3.56243648278E-10 3.78053799245E-10 4.01125210680E-10 4.25527852798E-10 4.51335470706E-10 4.78625784426E-10 5.07480699395E-10 5.37986527992E-10 5.70234222653E-10 6.04319621194E-10 6.40343704952E-10 6.78412870432E-10 7.18639215155E-10 7.61140838432E-10 8.06042157863E-10 8.53474242347E-10 9.03575162491E-10 9.56490359293E-10 1.01237303207E-09 1.07138454661E-09 1.13369486460E-09 1.19948299548E-09 1.26893747174E-09 1.34225684912E-09 1.41965023275E-09 1.50133783072E-09 1.58755153647E-09 1.67853554151E-09 1.77454697994E-09 1.87585660660E-09 1.98274951039E-09 2.09552586476E-09 2.21450171709E-09 2.34000981926E-09 2.47240050119E-09 2.61204258986E-09 2.75932437607E-09 2.91465463127E-09 3.07846367733E-09 3.25120451170E-09 3.43335399103E-09 3.62541407610E-09 3.82791314147E-09 4.04140735286E-09 4.26648211606E-09 4.50375360092E-09 4.75387034430E-09 5.01751493607E-09 5.29540579253E-09 5.58829902156E-09 5.89699038449E-09 6.22231735947E-09 6.56516131173E-09 6.92644977609E-09 7.30715885768E-09 7.70831575685E-09 8.13100142471E-09 8.57635335606E-09 9.04556852677E-09 9.53990648303E-09 1.00606925904E-08 1.06093214507E-08 1.11872604959E-08 1.17960537670E-08 1.24373258892E-08 1.31127862515E-08 1.38242334030E-08 1.45735596757E-08 1.53627560468E-08 1.61939172510E-08 1.70692471581E-08 1.79910644271E-08 1.89618084530E-08 1.99840456201E-08 2.10604758783E-08 2.21939396586E-08 2.33874251459E-08 2.46440759260E-08 2.59671990285E-08 2.73602733837E-08 2.88269587155E-08 3.03711048941E-08 3.19967617696E-08 3.37081895134E-08 3.55098694933E-08 3.74065157077E-08 3.94030868111E-08 4.15047987577E-08 4.37171380981E-08 4.60458759603E-08 4.84970827512E-08 5.10771436165E-08 5.37927746957E-08 5.66510402157E-08 5.96593704642E-08 6.28255806893E-08 6.61578909725E-08 6.96649471245E-08 7.33558426579E-08 7.72401418908E-08 8.13279042402E-08 8.56297097659E-08 9.01566860292E-08 9.49205363350E-08 9.99335694268E-08 1.05208730710E-07 1.10759635083E-07 1.16600601456E-07 1.22746689049E-07 1.29213735555E-07 1.36018397267E-07 1.43178191271E-07 1.50711539806E-07 1.58637816913E-07 1.66977397473E-07 1.75751708780E-07 1.84983284753E-07 1.94695822946E-07 2.04914244487E-07 2.15664757097E-07 2.26974921350E-07 2.38873720343E-07 2.51391632945E-07 2.64560710809E-07 2.78414659351E-07 2.92988922885E-07 3.08320774133E-07 3.24449408343E-07 3.41416042236E-07 3.59264018045E-07 3.78038912894E-07 3.97788653803E-07 4.18563638602E-07 4.40416863050E-07 4.63404054500E-07 4.87583812413E-07 5.13017756111E-07 5.39770680098E-07 5.67910717380E-07 5.97509511158E-07 6.28642395354E-07 6.61388584391E-07 6.95831372741E-07 7.32058344702E-07 7.70161594959E-07 8.10237960464E-07 8.52389264228E-07 8.96722571626E-07 9.43350459864E-07 9.92391301278E-07 1.04396956118E-06 1.09821611097E-06 1.15526855740E-06 1.21527158861E-06 1.27837733803E-06 1.34474576692E-06 1.41454506655E-06 1.48795208101E-06 1.56515275172E-06 1.64634258474E-06 1.73172714210E-06 1.82152255826E-06 1.91595608316E-06 2.01526665305E-06 2.11970549064E-06 2.22953673604E-06 2.34503811005E-06 2.46650161144E-06 2.59423425008E-06 2.72855881757E-06 2.86981469742E-06 3.01835871681E-06 3.17456604200E-06 3.33883111958E-06 3.51156866613E-06 3.69321470844E-06 3.88422767718E-06 4.08508955657E-06 4.29630709298E-06 4.51841306547E-06 4.75196762148E-06 4.99755968088E-06 5.25580841207E-06 5.52736478357E-06 5.81291319526E-06 6.11317319304E-06 6.42890127139E-06 6.76089276824E-06 7.10998385689E-06 7.47705363992E-06 7.86302635028E-06 8.26887366520E-06 8.69561713836E-06 9.14433075677E-06 9.61614362838E-06 1.01122428073E-05 1.06338762634E-05 1.11823560045E-05 1.17590613572E-05 1.23654424167E-05 1.30030236724E-05 1.36734078187E-05 1.43782797617E-05 1.51194108296E-05 1.58986631992E-05 1.67179945481E-05 1.75794629450E-05 1.84852319897E-05 1.94375762160E-05 2.04388867705E-05 2.14916773811E-05 2.25985906310E-05 2.37624045522E-05 2.49860395566E-05 2.62725657200E-05 2.76252104387E-05 2.90473664754E-05 3.05426004174E-05 3.21146615645E-05 3.37674912713E-05 3.55052327649E-05 3.73322414640E-05 3.92530958227E-05 4.12726087275E-05 4.33958394748E-05 4.56281063579E-05 4.79749998950E-05 5.04423967305E-05 5.30364742431E-05 5.57637258978E-05 5.86309773775E-05 6.16454035354E-05 6.48145462084E-05 6.81463329357E-05 7.16490966276E-05 7.53315962332E-05 7.92030384564E-05 8.32731005739E-05 8.75519544099E-05 9.20502915259E-05 9.67793496869E-05 1.01750940668E-04 1.06977479467E-04 1.12472014999E-04 1.18248262337E-04 1.24320636589E-04 1.30704288479E-04 1.37415141732E-04 1.44469932342E-04 1.51886249816E-04 1.59682580506E-04 1.67878353118E-04 1.76493986510E-04 1.85550939899E-04 1.95071765593E-04 2.05080164362E-04 2.15601043601E-04 2.26660578405E-04 2.38286275700E-04 2.50507041594E-04 2.63353252095E-04 2.76856827357E-04 2.91051309646E-04 3.05971945187E-04 3.21655770094E-04 3.38141700576E-04 3.55470627636E-04 3.73685516469E-04 3.92831510790E-04 4.12956042343E-04 4.34108945824E-04 4.56342579485E-04 4.79711951696E-04 5.04274853744E-04 5.30091999172E-04 5.57227169968E-04 5.85747369918E-04 6.15722985494E-04 6.47227954588E-04 6.80339943499E-04 7.15140532544E-04 7.51715410690E-04 7.90154579639E-04 8.30552567800E-04 8.73008654598E-04 9.17627105607E-04 9.64517418983E-04 1.01379458374E-03 1.06557935036E-03 1.11999851438E-03 1.17718521337E-03 1.23727923812E-03 1.30042735851E-03 1.36678366468E-03 1.43650992435E-03 1.50977595679E-03 1.58676002424E-03 1.66764924160E-03 1.75264000499E-03 1.84193844011E-03 1.93576087116E-03 2.03433431119E-03 2.13789697469E-03 2.24669881342E-03 2.36100207625E-03 2.48108189406E-03 2.60722689067E-03 2.73973982063E-03 2.87893823509E-03 3.02515517656E-03 3.17873990374E-03 3.34005864740E-03 3.50949539836E-03 3.68745272870E-03 3.87435264715E-03 4.07063748990E-03 4.27677084765E-03 4.49323853028E-03 4.72054956978E-03 4.95923726281E-03 5.20986025366E-03 5.47300365857E-03 5.74928023234E-03 6.03933157809E-03 6.34382940074E-03 6.66347680515E-03 6.99900963920E-03 7.35119788240E-03 7.72084708036E-03 8.10879982509E-03 8.51593728128E-03 8.94318075820E-03 9.39149332674E-03 9.86188148085E-03 1.03553968424E-02 1.08731379079E-02 1.14162518356E-02 1.19859362707E-02 1.25834412053E-02 1.32100708719E-02 1.38671856641E-02 1.45562040824E-02 1.52786046986E-02 1.60359281341E-02 1.68297790441E-02 1.76618281014E-02 1.85338139708E-02 1.94475452638E-02 2.04049024634E-02 2.14078398067E-02 2.24583871106E-02 2.35586515279E-02 2.47108192130E-02 2.59171568826E-02 2.71800132475E-02 2.85018202942E-02 2.98850943916E-02 3.13324371930E-02 3.28465363068E-02 3.44301656990E-02 3.60861857946E-02 3.78175432381E-02 3.96272702691E-02 4.15184836698E-02 4.34943832332E-02 4.55582496989E-02 4.77134420995E-02 4.99633944567E-02 5.23116117605E-02 5.47616651633E-02 5.73171863127E-02 5.99818607475E-02 6.27594202718E-02 6.56536342222E-02 6.86682995379E-02 7.18072295380E-02 7.50742413119E-02 7.84731416207E-02 8.20077112092E-02 8.56816874265E-02 8.94987450524E-02 9.34624752282E-02 9.75763623941E-02 1.01843759138E-01 1.06267858872E-01 1.10851666250E-01 1.15597965269E-01 1.20509284993E-01 1.25587862869E-01 1.30835605618E-01 1.36254047711E-01 1.41844307481E-01 1.47607040931E-01 1.53542393365E-01 1.59649949002E-01 1.65928678774E-01 1.72376886588E-01 1.78992154372E-01 1.85771286304E-01 1.92710252691E-01 1.99804134041E-01 2.07047065952E-01 2.14432185517E-01 2.21951580041E-01 2.29596238905E-01 2.37356009543E-01 2.45219558493E-01 2.53174338586E-01 2.61206563324E-01 2.69301189530E-01 2.77441909293E-01 2.85611152184E-01 2.93790098568E-01 3.01958704679E-01 3.10095739855E-01 3.18178836005E-01 3.26184548960E-01 3.34088430847E-01 3.41865112002E-01 3.49488390241E-01 3.56931324461E-01 3.64166328695E-01 3.71165261735E-01 3.77899506478E-01 3.84340032199E-01 3.90457432055E-01 3.96221927487E-01 4.01603330822E-01 4.06570957493E-01 4.11093480102E-01 4.15138718215E-01 4.18673360643E-01 4.21662621247E-01 4.24069835362E-01 4.25856012076E-01 4.26979368101E-01 4.27394881961E-01 4.27053922949E-01 4.25904027298E-01 4.23888914007E-01 4.20948853566E-01 4.17021522632E-01 4.12043494017E-01 4.05952519992E-01 3.98690762743E-01 3.90209101585E-01 3.80472593147E-01 3.69467067796E-01 3.57206699732E-01 3.43742178366E-01 3.29168822777E-01 3.13633615236E-01 2.97339692946E-01 2.80546360914E-01 2.63562250332E-01 2.46728990014E-01 2.30392944464E-01 2.14863636936E-01 2.00360128934E-01 1.86951996819E-01 1.74511371436E-01 1.62709456870E-01 1.51119028151E-01 1.39490339318E-01 1.27826927072E-01 1.16165063344E-01 1.04544024635E-01 9.30057699983E-02 8.15947745798E-02 7.03578533751E-02 5.93440078017E-02 4.86043263159E-02 3.81919785078E-02 2.81623370731E-02 1.85732419227E-02 9.48539272508E-03 9.62780468005E-04 -6.92699729493E-03 -1.41128183045E-02 -2.05208405509E-02 -2.60764101366E-02 -3.07073005420E-02 -3.43483317312E-02 -3.69470340254E-02 -3.84697983012E-02 -3.89077588123E-02 -3.82818523028E-02 -3.66467233839E-02 -3.40935296997E-02 -3.07517166270E-02 -2.67896670751E-02 -2.24135276451E-02 -1.78628810620E-02 -1.34012438764E-02 -9.29903444951E-03 -5.80685156366E-03 -3.11825327827E-03 -1.32462156882E-03 -3.71709039155E-04 -4.07023882066E-05 -1.28729902376E-07 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 8.88528774498E+00 -2.71337363883E+01 -3.02428797365E+01 3.77380495373E+02 -1.04094865691E+03 1.41341895219E+03 -9.64757220979E+02 2.63709556226E+02 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2 4 1 i j (l(j)) 0.00000000000E+00 Q_int 0.00000000000E+00 1.22965902189E-17 1.00873546049E-16 3.49127310873E-16 8.48717088852E-16 1.70014534993E-15 3.01337378001E-15 4.90847669244E-15 7.51633402691E-15 1.09793661783E-14 1.54523130197E-14 2.11030596138E-14 2.81135112408E-14 3.66805205153E-14 4.70168695146E-14 5.93523099996E-14 7.39346649755E-14 9.10309950161E-14 1.10928832961E-13 1.33937490790E-13 1.60389442679E-13 1.90641788470E-13 2.25077802002E-13 2.64108568996E-13 3.08174719440E-13 3.57748259683E-13 4.13334509728E-13 4.75474151508E-13 5.44745394239E-13 6.21766263269E-13 7.07197019192E-13 8.01742714340E-13 9.06155894180E-13 1.02123945150E-12 1.14784964171E-12 1.28689926809E-12 1.43936104612E-12 1.60627115671E-12 1.78873299853E-12 1.98792115030E-12 2.20508555431E-12 2.44155593318E-12 2.69874645256E-12 2.97816064287E-12 3.28139659419E-12 3.61015243894E-12 3.96623213800E-12 4.35155158628E-12 4.76814505528E-12 5.21817199046E-12 5.70392418262E-12 6.22783333318E-12 6.79247903472E-12 7.40059718867E-12 8.05508888384E-12 8.75902976022E-12 9.51567988403E-12 1.03284941614E-11 1.12011333189E-11 1.21374754826E-11 1.31416283848E-11 1.42179422350E-11 1.53710232883E-11 1.66057481489E-11 1.79272788476E-11 1.93410787354E-11 2.08529292345E-11 2.24689474942E-11 2.41956049982E-11 2.60397471744E-11 2.80086140603E-11 3.01098620793E-11 3.23515869869E-11 3.47423480489E-11 3.72911935166E-11 4.00076874663E-11 4.29019380772E-11 4.59846274219E-11 4.92670428493E-11 5.27611100447E-11 5.64794278548E-11 6.04353049703E-11 6.46427985646E-11 6.91167549897E-11 7.38728526405E-11 7.89276470980E-11 8.42986186731E-11 9.00042224769E-11 9.60639411491E-11 1.02498340385E-10 1.09329127407E-10 1.16579212534E-10 1.24272774017E-10 1.32435326299E-10 1.41093791896E-10 1.50276577070E-10 1.60013651509E-10 1.70336632212E-10 1.81278871806E-10 1.92875551516E-10 2.05163779050E-10 2.18182691637E-10 2.31973564494E-10 2.46579925006E-10 2.62047672923E-10 2.78425206872E-10 2.95763557528E-10 3.14116527788E-10 3.33540840305E-10 3.54096292774E-10 3.75845921376E-10 3.98856172791E-10 4.23197085242E-10 4.48942479030E-10 4.76170157057E-10 5.04962115855E-10 5.35404767675E-10 5.67589174195E-10 6.01611292470E-10 6.37572233743E-10 6.75578535800E-10 7.15742449561E-10 7.58182240653E-10 8.03022506737E-10 8.50394511421E-10 9.00436535592E-10 9.53294247109E-10 1.00912108977E-09 1.06807869258E-09 1.13033730037E-09 1.19607622686E-09 1.26548433134E-09 1.33876052017E-09 1.41611427445E-09 1.49776620516E-09 1.58394863716E-09 1.67490622362E-09 1.77089659245E-09 1.87219102634E-09 1.97907517813E-09 2.09184982347E-09 2.21083165253E-09 2.33635410286E-09 2.46876823564E-09 2.60844365729E-09 2.75576948906E-09 2.91115538694E-09 3.07503261454E-09 3.24785517160E-09 3.43010098113E-09 3.62227313813E-09 3.82490122304E-09 4.03854268341E-09 4.26378428710E-09 4.50124365088E-09 4.75157084831E-09 5.01545010084E-09 5.29360155660E-09 5.58678316138E-09 5.89579262641E-09 6.22146949818E-09 6.56469733532E-09 6.92640599825E-09 7.30757405730E-09 7.70923132549E-09 8.13246152241E-09 8.57840507578E-09 9.04826206811E-09 9.54329533564E-09 1.00648337276E-08 1.06142755339E-08 1.11930920904E-08 1.18028315696E-08 1.24451229687E-08 1.31216803024E-08 1.38343070131E-08 1.45849006086E-08 1.53754575395E-08 1.62080783290E-08 1.70849729663E-08 1.80084665801E-08 1.89810054038E-08 2.00051630496E-08 2.10836471054E-08 2.22193060733E-08 2.34151366652E-08 2.46742914757E-08 2.60000870504E-08 2.73960123702E-08 2.88657377743E-08 3.04131243419E-08 3.20422337592E-08 3.37573386944E-08 3.55629337078E-08 3.74637467245E-08 3.94647510988E-08 4.15711782998E-08 4.37885312516E-08 4.61225983606E-08 4.85794682657E-08 5.11655453489E-08 5.38875660447E-08 5.67526159900E-08 5.97681480570E-08 6.29420013160E-08 6.62824209739E-08 6.97980793399E-08 7.34980978717E-08 7.73920703550E-08 8.14900872791E-08 8.58027614655E-08 9.03412550163E-08 9.51173076512E-08 1.00143266501E-07 1.05432117437E-07 1.10997518009E-07 1.16853832085E-07 1.23016166266E-07 1.29500408179E-07 1.36323266740E-07 1.43502314487E-07 1.51056032092E-07 1.59003855161E-07 1.67366223447E-07 1.76164632585E-07 1.85421688495E-07 1.95161164582E-07 2.05408061876E-07 2.16188672263E-07 2.27530644972E-07 2.39463056477E-07 2.52016483992E-07 2.65223082749E-07 2.79116667243E-07 2.93732796660E-07 3.09108864688E-07 3.25284193951E-07 3.42300135292E-07 3.60200172164E-07 3.79030030379E-07 3.98837793497E-07 4.19674024153E-07 4.41591891609E-07 4.64647305859E-07 4.88899058630E-07 5.14408971625E-07 5.41242052373E-07 5.69466658099E-07 5.99154667997E-07 6.30381664361E-07 6.63227123013E-07 6.97774613515E-07 7.34112009656E-07 7.72331710758E-07 8.12530874332E-07 8.54811660695E-07 8.99281490129E-07 9.46053313263E-07 9.95245895311E-07 1.04698411492E-06 1.10139927837E-06 1.15862944985E-06 1.21881979873E-06 1.28212296466E-06 1.34869944139E-06 1.41871798028E-06 1.49235601449E-06 1.56980010503E-06 1.65124640960E-06 1.73690117552E-06 1.82698125793E-06 1.92171466463E-06 2.02134112879E-06 2.12611271111E-06 2.23629443277E-06 2.35216494096E-06 2.47401720844E-06 2.60215926904E-06 2.73691499082E-06 2.87862488890E-06 3.02764697998E-06 3.18435768067E-06 3.34915275177E-06 3.52244829110E-06 3.70468177716E-06 3.89631316619E-06 4.09782604561E-06 4.30972884644E-06 4.53255611791E-06 4.76686986734E-06 5.01326096866E-06 5.27235064315E-06 5.54479201593E-06 5.83127175223E-06 6.13251177742E-06 6.44927108520E-06 6.78234763826E-06 7.13258036635E-06 7.50085126656E-06 7.88808761118E-06 8.29526426850E-06 8.72340614242E-06 9.17359073691E-06 9.64695085163E-06 1.01446774155E-05 1.06680224652E-05 1.12183022761E-05 1.17969006530E-05 1.24052723897E-05 1.30449469048E-05 1.37175320638E-05 1.44247181965E-05 1.51682823196E-05 1.59500925750E-05 1.67721128951E-05 1.76364079063E-05 1.85451480827E-05 1.95006151634E-05 2.05052078460E-05 2.15614477711E-05 2.26719858118E-05 2.38396086846E-05 2.50672458970E-05 2.63579770500E-05 2.77150395130E-05 2.91418364893E-05 3.06419454938E-05 3.22191272616E-05 3.38773351114E-05 3.56207247855E-05 3.74536647905E-05 3.93807472653E-05 4.14067994012E-05 4.35368954442E-05 4.57763693069E-05 4.81308278220E-05 5.06061646700E-05 5.32085750139E-05 5.59445708780E-05 5.88209973076E-05 6.18450493489E-05 6.50242898905E-05 6.83666684107E-05 7.18805406742E-05 7.55746894286E-05 7.94583461486E-05 8.35412138814E-05 8.78334912493E-05 9.23458976661E-05 9.70896998291E-05 1.02076739550E-04 1.07319462993E-04 1.12830951388E-04 1.18624953291E-04 1.24715918481E-04 1.31119033554E-04 1.37850259320E-04 1.44926370073E-04 1.52364994848E-04 1.60184660741E-04 1.68404838415E-04 1.77045989883E-04 1.86129618696E-04 1.95678322637E-04 2.05715849064E-04 2.16267153015E-04 2.27358458223E-04 2.39017321178E-04 2.51272698381E-04 2.64155016960E-04 2.77696248798E-04 2.91929988346E-04 3.06891534309E-04 3.22617975387E-04 3.39148280259E-04 3.56523392038E-04 3.74786327379E-04 3.93982280501E-04 4.14158732325E-04 4.35365564998E-04 4.57655182040E-04 4.81082634403E-04 5.05705752697E-04 5.31585285895E-04 5.58785046819E-04 5.87372064708E-04 6.17416745229E-04 6.48993038248E-04 6.82178613746E-04 7.17055046240E-04 7.53708008105E-04 7.92227472215E-04 8.32707924313E-04 8.75248585561E-04 9.19953645728E-04 9.66932507498E-04 1.01630004239E-03 1.06817685878E-03 1.12268958267E-03 1.17997115154E-03 1.24016112215E-03 1.30340599260E-03 1.36985953947E-03 1.43968317063E-03 1.51304629425E-03 1.59012670492E-03 1.67111098738E-03 1.75619493871E-03 1.84558400963E-03 1.93949376574E-03 2.03815036954E-03 2.14179108385E-03 2.25066479767E-03 2.36503257514E-03 2.48516822865E-03 2.61135891679E-03 2.74390576814E-03 2.88312453178E-03 3.02934625544E-03 3.18291799219E-03 3.34420353659E-03 3.51358419125E-03 3.69145956475E-03 3.87824840172E-03 4.07438944613E-03 4.28034233854E-03 4.49658854831E-03 4.72363234142E-03 4.96200178487E-03 5.21224978826E-03 5.47495518333E-03 5.75072384194E-03 6.04018983321E-03 6.34401662005E-03 6.66289829554E-03 6.99756085925E-03 7.34876353365E-03 7.71730012041E-03 8.10400039633E-03 8.50973154824E-03 8.93539964643E-03 9.38195115511E-03 9.85037447903E-03 1.03417015443E-02 1.08570094113E-02 1.13974219176E-02 1.19641113476E-02 1.25583001255E-02 1.31812625277E-02 1.38343264101E-02 1.45188749447E-02 1.52363483595E-02 1.59882456751E-02 1.67761264300E-02 1.76016123854E-02 1.84663892007E-02 1.93722080673E-02 2.03208872894E-02 2.13143137977E-02 2.23544445807E-02 2.34433080168E-02 2.45830050887E-02 2.57757104594E-02 2.70236733872E-02 2.83292184547E-02 2.96947460856E-02 3.11227328183E-02 3.26157313045E-02 3.41763699983E-02 3.58073524960E-02 3.75114564863E-02 3.92915322656E-02 4.11505007696E-02 4.30913510701E-02 4.51171372790E-02 4.72309748015E-02 4.94360358726E-02 5.17355443092E-02 5.41327694045E-02 5.66310188882E-02 5.92336308695E-02 6.19439646787E-02 6.47653905163E-02 6.77012778165E-02 7.07549822259E-02 7.39298310995E-02 7.72291074077E-02 8.06560319505E-02 8.42137437722E-02 8.79052786694E-02 9.17335456874E-02 9.57013015006E-02 9.98111225801E-02 1.04065375055E-01 1.08466182182E-01 1.13015389354E-01 1.17714526586E-01 1.22564768440E-01 1.27566891365E-01 1.32721228461E-01 1.38027621709E-01 1.43485371723E-01 1.49093185150E-01 1.54849119870E-01 1.60750528206E-01 1.66793998413E-01 1.72975294785E-01 1.79289296774E-01 1.85729937625E-01 1.92290143069E-01 1.98961770752E-01 2.05735551135E-01 2.12601030719E-01 2.19546518529E-01 2.26559036895E-01 2.33624277663E-01 2.40726565024E-01 2.47848826262E-01 2.54972571712E-01 2.62077885309E-01 2.69143427035E-01 2.76146448577E-01 2.83062823362E-01 2.89867092023E-01 2.96532524070E-01 3.03031196285E-01 3.09334087916E-01 3.15411192275E-01 3.21231643752E-01 3.26763858531E-01 3.31975686509E-01 3.36834571015E-01 3.41307711958E-01 3.45362227034E-01 3.48965304623E-01 3.52084341100E-01 3.54687054545E-01 3.56741566389E-01 3.58216442549E-01 3.59080686225E-01 3.59303676034E-01 3.58855045756E-01 3.57704505955E-01 3.55821613468E-01 3.53175502416E-01 3.49734600394E-01 3.45466365945E-01 3.40337098332E-01 3.34311887961E-01 3.27354794842E-01 3.19429362305E-01 3.10499592042E-01 3.00531521690E-01 2.89495553883E-01 2.77369680555E-01 2.64143721267E-01 2.49824640932E-01 2.34442918844E-01 2.18059797231E-01 2.00775028782E-01 1.82734460691E-01 1.64136432589E-01 1.45235535107E-01 1.26341809858E-01 1.07813042604E-01 9.00375573199E-02 7.34051140078E-02 5.82645817879E-02 4.48697054328E-02 3.33196160442E-02 2.35104877606E-02 1.51315376722E-02 7.76637651327E-03 1.16654904033E-03 -4.67404023202E-03 -9.73804498439E-03 -1.40150035542E-02 -1.75021343667E-02 -2.02049975944E-02 -2.21381418132E-02 -2.33257229925E-02 -2.38020688022E-02 -2.36121475024E-02 -2.28118762737E-02 -2.14681713424E-02 -1.96586080971E-02 -1.74705234686E-02 -1.49993847630E-02 -1.23462795604E-02 -9.61448780452E-03 -6.90528292383E-03 -4.31334205141E-03 -1.92236764529E-03 1.98422119250E-04 1.99640689022E-03 3.43617683426E-03 4.49895766556E-03 5.18157054288E-03 5.49558803725E-03 5.46714677669E-03 5.13723963373E-03 4.56197620370E-03 3.81181101374E-03 2.96885683840E-03 2.12131572543E-03 1.35464462998E-03 7.39478919285E-04 3.17707444905E-04 8.97932301059E-05 9.83408294870E-06 -9.64228889273E-08 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 9.37420047405E+00 -3.38353181685E+01 -1.10701833774E+01 3.46691777824E+02 -1.00438926518E+03 1.38104237532E+03 -9.47081789285E+02 2.59479328886E+02 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2 5 2 i j (l(j)) 0.00000000000E+00 Q_int 0.00000000000E+00 -6.71135300192E-24 -1.11036781705E-22 -5.81311497477E-22 -1.90012021056E-21 -4.79820226002E-21 -1.02920326467E-20 -1.97254139497E-20 -3.48154418345E-20 -5.77032367526E-20 -9.10098666551E-20 -1.37897920259E-19 -2.02139227825E-19 -2.88189266699E-19 -4.01268832285E-19 -5.47453601861E-19 -7.33772268988E-19 -9.68313980438E-19 -1.26034586592E-18 -1.62044151360E-18 -2.06062131206E-18 -2.59450565191E-18 -3.23748205845E-18 -4.00688741106E-18 -4.92220649515E-18 -6.00528823000E-18 -7.28058102025E-18 -8.77538879135E-18 -1.05201493899E-17 -1.25487371601E-17 -1.48987916468E-17 -1.76120745253E-17 -2.07348570206E-17 -2.43183402502E-17 -2.84191111120E-17 -3.30996365372E-17 -3.84287991450E-17 -4.44824775640E-17 -5.13441749331E-17 -5.91056993632E-17 -6.78679004219E-17 -7.77414660127E-17 -8.88477843495E-17 -1.01319876077E-16 -1.15303401969E-16 -1.30957752045E-16 -1.48457222372E-16 -1.67992286307E-16 -1.89770967407E-16 -2.14020321804E-16 -2.40988038408E-16 -2.70944165899E-16 -3.04182976186E-16 -3.41024974666E-16 -3.81819068425E-16 -4.26944904322E-16 -4.76815389780E-16 -5.31879410065E-16 -5.92624756820E-16 -6.59581283734E-16 -7.33324306371E-16 -8.14478264436E-16 -9.03720666102E-16 -1.00178633543E-15 -1.10947198548E-15 -1.22764114133E-15 -1.35722943904E-15 -1.49925032837E-15 -1.65480120923E-15 -1.82507003396E-15 -2.01134240976E-15 -2.21500923833E-15 -2.43757493211E-15 -2.68066624977E-15 -2.94604179629E-15 -3.23560223652E-15 -3.55140127454E-15 -3.89565745488E-15 -4.27076684574E-15 -4.67931666869E-15 -5.12409994396E-15 -5.60813122532E-15 -6.13466350403E-15 -6.70720636690E-15 -7.32954549955E-15 -8.00576363283E-15 -8.74026303679E-15 -9.53778967475E-15 -1.04034591374E-14 -1.13427844860E-14 -1.23617061425E-14 -1.34666239747E-14 -1.46644317348E-14 -1.59625540207E-14 -1.73689859425E-14 -1.88923356884E-14 -2.05418701994E-14 -2.23275641752E-14 -2.42601526511E-14 -2.63511874030E-14 -2.86130974541E-14 -3.10592539775E-14 -3.37040399097E-14 -3.65629246130E-14 -3.96525439466E-14 -4.29907861336E-14 -4.65968838394E-14 -5.04915129018E-14 -5.46968981910E-14 -5.92369271060E-14 -6.41372712507E-14 -6.94255168754E-14 -7.51313047046E-14 -8.12864798206E-14 -8.79252523172E-14 -9.50843694896E-14 -1.02803300379E-13 -1.11124433550E-13 -1.20093289039E-13 -1.29758745478E-13 -1.40173283475E-13 -1.51393246387E-13 -1.63479119746E-13 -1.76495830621E-13 -1.90513068364E-13 -2.05605628222E-13 -2.21853779451E-13 -2.39343659654E-13 -2.58167697197E-13 -2.78425063686E-13 -3.00222158629E-13 -3.23673128542E-13 -3.48900422949E-13 -3.76035389849E-13 -4.05218913459E-13 -4.36602097189E-13 -4.70346995041E-13 -5.06627394845E-13 -5.45629656972E-13 -5.87553612432E-13 -6.32613524520E-13 -6.81039118495E-13 -7.33076684056E-13 -7.88990255734E-13 -8.49062876673E-13 -9.13597951650E-13 -9.82920695594E-13 -1.05737968431E-12 -1.13734851458E-12 -1.22322758126E-12 -1.31544597968E-12 -1.41446354202E-12 -1.52077301705E-12 -1.63490240341E-12 -1.75741744700E-12 -1.88892431405E-12 -2.03007245221E-12 -2.18155765271E-12 -2.34412532775E-12 -2.51857401809E-12 -2.70575914697E-12 -2.90659703762E-12 -3.12206921265E-12 -3.35322699518E-12 -3.60119643261E-12 -3.86718356571E-12 -4.15248006704E-12 -4.45846927453E-12 -4.78663264772E-12 -5.13855667628E-12 -5.51594027218E-12 -5.92060267947E-12 -6.35449193748E-12 -6.81969393628E-12 -7.31844210549E-12 -7.85312778071E-12 -8.42631129469E-12 -9.04073384377E-12 -9.69933018356E-12 -1.04052422117E-11 -1.11618334991E-11 -1.19727048366E-11 -1.28417108661E-11 -1.37729778739E-11 -1.47709228245E-11 -1.58402737234E-11 -1.69860914002E-11 -1.82137928109E-11 -1.95291759654E-11 -2.09384465925E-11 -2.24482466639E-11 -2.40656849067E-11 -2.57983694407E-11 -2.76544426908E-11 -2.96426187308E-11 -3.17722232276E-11 -3.40532361671E-11 -3.64963375550E-11 -3.91129562982E-11 -4.19153224888E-11 -4.49165233254E-11 -4.81305629263E-11 -5.15724263030E-11 -5.52581477831E-11 -5.92048841917E-11 -6.34309931219E-11 -6.79561166463E-11 -7.28012708471E-11 -7.79889415707E-11 -8.35431868343E-11 -8.94897463500E-11 -9.58561586574E-11 -1.02671886393E-10 -1.09968450261E-10 -1.17779572306E-10 -1.26141329140E-10 -1.35092315801E-10 -1.44673820992E-10 -1.54930014483E-10 -1.65908147523E-10 -1.77658767150E-10 -1.90235945389E-10 -2.03697524336E-10 -2.18105378257E-10 -2.33525693862E-10 -2.50029270020E-10 -2.67691838265E-10 -2.86594405523E-10 -3.06823620606E-10 -3.28472166114E-10 -3.51639177516E-10 -3.76430691265E-10 -4.02960123991E-10 -4.31348784893E-10 -4.61726423647E-10 -4.94231816282E-10 -5.29013391644E-10 -5.66229901273E-10 -6.06051135679E-10 -6.48658690242E-10 -6.94246784156E-10 -7.43023136100E-10 -7.95209900550E-10 -8.51044668932E-10 -9.10781540095E-10 -9.74692264908E-10 -1.04306747010E-09 -1.11621796681E-09 -1.19447614977E-09 -1.27819749326E-09 -1.36776215066E-09 -1.46357666471E-09 -1.56607579609E-09 -1.67572447855E-09 -1.79301990938E-09 -1.91849378440E-09 -2.05271468773E-09 -2.19629064678E-09 -2.34987186403E-09 -2.51415363778E-09 -2.68987948494E-09 -2.87784447975E-09 -3.07889882348E-09 -3.29395166100E-09 -3.52397516121E-09 -3.77000887971E-09 -4.03316442310E-09 -4.31463043577E-09 -4.61567793151E-09 -4.93766599368E-09 -5.28204786946E-09 -5.65037748539E-09 -6.04431641329E-09 -6.46564131768E-09 -6.91625191794E-09 -7.39817950077E-09 -7.91359602100E-09 -8.46482383125E-09 -9.05434608404E-09 -9.68481785269E-09 -1.03590780206E-08 -1.10801619922E-08 -1.18513152818E-08 -1.26760080415E-08 -1.35579505932E-08 -1.45011100325E-08 -1.55097279808E-08 -1.65883395632E-08 -1.77417936966E-08 -1.89752747808E-08 -2.02943258861E-08 -2.17048735432E-08 -2.32132542453E-08 -2.48262427800E-08 -2.65510825179E-08 -2.83955177934E-08 -3.03678285203E-08 -3.24768671987E-08 -3.47320984767E-08 -3.71436414435E-08 -3.97223148429E-08 -4.24796854081E-08 -4.54281195332E-08 -4.85808385124E-08 -5.19519775919E-08 -5.55566490986E-08 -5.94110099262E-08 -6.35323336791E-08 -6.79390877969E-08 -7.26510160008E-08 -7.76892264308E-08 -8.30762858658E-08 -8.88363204459E-08 -9.49951233451E-08 -1.01580269874E-07 -1.08621240528E-07 -1.16149552521E-07 -1.24198900397E-07 -1.32805306347E-07 -1.42007280892E-07 -1.51845994654E-07 -1.62365461977E-07 -1.73612737215E-07 -1.85638124561E-07 -1.98495402350E-07 -2.12242062836E-07 -2.26939568505E-07 -2.42653626065E-07 -2.59454479342E-07 -2.77417222363E-07 -2.96622134043E-07 -3.17155035944E-07 -3.39107674710E-07 -3.62578130867E-07 -3.87671255818E-07 -4.14499138964E-07 -4.43181607029E-07 -4.73846757817E-07 -5.06631530759E-07 -5.41682316796E-07 -5.79155610300E-07 -6.19218705930E-07 -6.62050443529E-07 -7.07842004346E-07 -7.56797762142E-07 -8.09136192949E-07 -8.65090847518E-07 -9.24911390772E-07 -9.88864712889E-07 -1.05723611693E-06 -1.13033058827E-06 -1.20847415153E-06 -1.29201532090E-06 -1.38132665046E-06 -1.47680639118E-06 -1.57888026207E-06 -1.68800334335E-06 -1.80466209993E-06 -1.92937654417E-06 -2.06270254766E-06 -2.20523431201E-06 -2.35760700982E-06 -2.52049960738E-06 -2.69463788160E-06 -2.88079764462E-06 -3.07980819022E-06 -3.29255597742E-06 -3.51998856738E-06 -3.76311883122E-06 -4.02302944710E-06 -4.30087770665E-06 -4.59790065183E-06 -4.91542056494E-06 -5.25485083600E-06 -5.61770223338E-06 -6.00558960536E-06 -6.42023904205E-06 -6.86349552937E-06 -7.33733112862E-06 -7.84385371788E-06 -8.38531633338E-06 -8.96412715218E-06 -9.58286015992E-06 -1.02442665505E-05 -1.09512869076E-05 -1.17070642221E-05 -1.25149578010E-05 -1.33785581308E-05 -1.43017027590E-05 -1.52884932629E-05 -1.63433133815E-05 -1.74708483883E-05 -1.86761057896E-05 -1.99644374397E-05 -2.13415631674E-05 -2.28135960188E-05 -2.43870692242E-05 -2.60689650076E-05 -2.78667453625E-05 -2.97883849286E-05 -3.18424061103E-05 -3.40379165896E-05 -3.63846493948E-05 -3.88930056980E-05 -4.15741005243E-05 -4.44398115701E-05 -4.75028313395E-05 -5.07767228205E-05 -5.42759789405E-05 -5.80160860524E-05 -6.20135917226E-05 -6.62861771069E-05 -7.08527342216E-05 -7.57334484344E-05 -8.09498865223E-05 -8.65250906667E-05 -9.24836787764E-05 -9.88519515582E-05 -1.05658006778E-04 -1.12931861188E-04 -1.20705580614E-04 -1.29013418746E-04 -1.37891965194E-04 -1.47380303410E-04 -1.57520179110E-04 -1.68356179887E-04 -1.79935926713E-04 -1.92310278109E-04 -2.05533547775E-04 -2.19663736543E-04 -2.34762779540E-04 -2.50896809535E-04 -2.68136437459E-04 -2.86557051173E-04 -3.06239133594E-04 -3.27268601375E-04 -3.49737165370E-04 -3.73742714198E-04 -3.99389722283E-04 -4.26789683804E-04 -4.56061574076E-04 -4.87332339928E-04 -5.20737420750E-04 -5.56421301912E-04 -5.94538102356E-04 -6.35252198225E-04 -6.78738884454E-04 -7.25185076319E-04 -7.74790052995E-04 -8.27766245250E-04 -8.84340069416E-04 -9.44752809859E-04 -1.00926155217E-03 -1.07814016935E-03 -1.15168036324E-03 -1.23019276345E-03 -1.31400808605E-03 -1.40347835411E-03 -1.49897818226E-03 -1.60090612724E-03 -1.70968610621E-03 -1.82576888459E-03 -1.94963363468E-03 -2.08178956629E-03 -2.22277763020E-03 -2.37317229460E-03 -2.53358339463E-03 -2.70465805405E-03 -2.88708267786E-03 -3.08158501348E-03 -3.28893627753E-03 -3.50995334401E-03 -3.74550098855E-03 -3.99649418212E-03 -4.26390042589E-03 -4.54874211739E-03 -4.85209893619E-03 -5.17511023497E-03 -5.51897741968E-03 -5.88496629978E-03 -6.27440938645E-03 -6.68870811384E-03 -7.12933495437E-03 -7.59783539579E-03 -8.09582974313E-03 -8.62501470452E-03 -9.18716471477E-03 -9.78413294575E-03 -1.04178519469E-02 -1.10903338538E-02 -1.18036700966E-02 -1.25600305341E-02 -1.33616619330E-02 -1.42108857055E-02 -1.51100948123E-02 -1.60617497329E-02 -1.70683733974E-02 -1.81325449721E-02 -1.92568923832E-02 -2.04440834649E-02 -2.16968156100E-02 -2.30178038075E-02 -2.44097669499E-02 -2.58754122976E-02 -2.74174179990E-02 -2.90384135717E-02 -3.07409582693E-02 -3.25275172756E-02 -3.44004356968E-02 -3.63619103493E-02 -3.84139593820E-02 -4.05583898140E-02 -4.27967631216E-02 -4.51303590643E-02 -4.75601380098E-02 -5.00867020849E-02 -5.27102555600E-02 -5.54305649578E-02 -5.82469194578E-02 -6.11580922538E-02 -6.41623036010E-02 -6.72571863549E-02 -7.04397548600E-02 -7.37063780748E-02 -7.70527578142E-02 -8.04739129435E-02 -8.39641702539E-02 -8.75171625749E-02 -9.11258344162E-02 -9.47824550743E-02 -9.84786386556E-02 -1.02205369858E-01 -1.05953033599E-01 -1.09711445674E-01 -1.13469880566E-01 -1.17217091342E-01 -1.20941315277E-01 -1.24630257461E-01 -1.28271043323E-01 -1.31850129802E-01 -1.35353163925E-01 -1.38764777177E-01 -1.42068304324E-01 -1.45245416778E-01 -1.48275663470E-01 -1.51135917031E-01 -1.53799730286E-01 -1.56236618295E-01 -1.58411294765E-01 -1.60282909062E-01 -1.61804351348E-01 -1.62921718375E-01 -1.63574060117E-01 -1.63693556104E-01 -1.63206296726E-01 -1.62033864164E-01 -1.60095912849E-01 -1.57313930726E-01 -1.53616307313E-01 -1.48944726918E-01 -1.43261727496E-01 -1.36558999396E-01 -1.28865630182E-01 -1.20255030587E-01 -1.10848728697E-01 -1.00814672276E-01 -9.03573014041E-02 -7.96967682409E-02 -6.90358637104E-02 -5.85164419020E-02 -4.81740284098E-02 -3.79124571121E-02 -2.75439032050E-02 -1.69548635172E-02 -6.17680327955E-03 4.73534581552E-03 1.57211958417E-02 2.67149642864E-02 3.76456060656E-02 4.84370677584E-02 5.90087009738E-02 6.92758726398E-02 7.91508206490E-02 8.85438061401E-02 9.73646071761E-02 1.05524387962E-01 1.12937925827E-01 1.19526127736E-01 1.25218647846E-01 1.29956340674E-01 1.33693161644E-01 1.36397166609E-01 1.38050323304E-01 1.38647162676E-01 1.38192545534E-01 1.36699177021E-01 1.34185502091E-01 1.30674581187E-01 1.26194126594E-01 1.20777677787E-01 1.14466575152E-01 1.07312524194E-01 9.93805482453E-02 9.07524427093E-02 8.15308157158E-02 7.18439074551E-02 6.18510637362E-02 5.17484792284E-02 4.17741679731E-02 3.22104948474E-02 2.33818221492E-02 1.56433844347E-02 9.33722095988E-03 4.70566106467E-03 1.80223697076E-03 4.10684039371E-04 2.38319313636E-05 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 -4.67386464358E+00 3.37046441377E+00 1.07679033450E+02 -5.43222644071E+02 1.25478098572E+03 -1.55722585339E+03 1.00032461551E+03 -2.61170397725E+02 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2 6 2 i j (l(j)) 0.00000000000E+00 Q_int 0.00000000000E+00 1.30292831382E-23 2.15564531800E-22 1.12854622458E-21 3.68885442520E-21 9.31513150667E-21 1.99807411984E-20 3.82945142802E-20 6.75899850771E-20 1.12023880942E-19 1.76684689465E-19 2.67712195550E-19 3.92428953144E-19 5.59484734632E-19 7.79015085187E-19 1.06281520013E-18 1.42453044106E-18 1.87986491169E-18 2.44680962767E-18 3.14589193633E-18 4.00044797365E-18 5.03692008673E-18 6.28518130177E-18 7.77888908102E-18 9.55587078745E-18 1.16585434651E-17 1.41343707455E-17 1.70363599099E-17 2.04236023697E-17 2.43618610824E-17 2.89242086887E-17 3.41917204490E-17 4.02542263712E-17 4.72111272552E-17 5.51722797445E-17 6.42589558590E-17 7.46048829039E-17 8.63573700928E-17 9.96785287085E-17 1.14746593136E-16 1.31757350657E-16 1.50925688500E-16 1.72487267255E-16 1.96700330475E-16 2.23847661002E-16 2.54238695350E-16 2.88211808334E-16 3.26136781024E-16 3.68417466087E-16 4.15494665650E-16 4.67849237881E-16 5.26005449756E-16 5.90534594726E-16 6.62058895400E-16 7.41255712844E-16 8.28862085689E-16 9.25679623946E-16 1.03257978427E-15 1.15050955536E-15 1.28049758431E-15 1.42366077696E-15 1.58121140777E-15 1.75446477720E-15 1.94484745765E-15 2.15390617151E-15 2.38331734870E-15 2.63489741386E-15 2.91061385760E-15 3.21259714963E-15 3.54315355627E-15 3.90477892901E-15 4.30017353589E-15 4.73225801243E-15 5.20419051456E-15 5.71938516196E-15 6.28153186645E-15 6.89461764706E-15 7.56294954067E-15 8.29117922503E-15 9.08432947908E-15 9.94782261509E-15 1.08875110260E-14 1.19097100025E-14 1.30212329844E-14 1.42294294243E-14 1.55422254523E-14 1.69681675452E-14 1.85164694192E-14 2.01970623772E-14 2.20206493634E-14 2.39987629915E-14 2.61438278339E-14 2.84692272798E-14 3.09893752915E-14 3.37197934121E-14 3.66771934024E-14 3.98795659117E-14 4.33462756177E-14 4.70981632984E-14 5.11576553354E-14 5.55488811798E-14 6.02977993534E-14 6.54323325951E-14 7.09825128084E-14 7.69806365099E-14 8.34614315305E-14 9.04622357729E-14 9.80231888863E-14 1.06187437779E-13 1.15001356960E-13 1.24514784755E-13 1.34781276547E-13 1.45858376233E-13 1.57807907206E-13 1.70696284241E-13 1.84594847787E-13 1.99580222235E-13 2.15734699879E-13 2.33146652387E-13 2.51910971739E-13 2.72129542712E-13 2.93911749155E-13 3.17375016441E-13 3.42645392659E-13 3.69858171295E-13 3.99158558316E-13 4.30702386818E-13 4.64656882589E-13 5.01201484174E-13 5.40528721308E-13 5.82845155826E-13 6.28372389453E-13 6.77348143197E-13 7.30027413393E-13 7.86683709791E-13 8.47610381475E-13 9.13122036788E-13 9.83556063890E-13 1.05927425902E-12 1.14066457003E-12 1.22814296333E-12 1.32215542288E-12 1.42318009050E-12 1.53172955746E-12 1.64835331798E-12 1.77364039594E-12 1.90822215702E-12 2.05277531921E-12 2.20802517574E-12 2.37474904508E-12 2.55377996422E-12 2.74601064203E-12 2.95239769104E-12 3.17396615714E-12 3.41181436797E-12 3.66711912242E-12 3.94114124505E-12 4.23523153094E-12 4.55083710830E-12 4.88950824808E-12 5.25290565175E-12 5.64280825079E-12 6.06112155348E-12 6.50988657740E-12 6.99128940837E-12 7.50767142977E-12 8.06154026883E-12 8.65558151008E-12 9.29267122945E-12 9.97588940628E-12 1.07085342744E-11 1.14941376778E-11 1.23364815013E-11 1.32396152503E-11 1.42078748608E-11 1.52459028240E-11 1.63586697192E-11 1.75514972507E-11 1.88300828949E-11 2.02005262697E-11 2.16693573455E-11 2.32435666263E-11 2.49306374383E-11 2.67385804723E-11 2.86759707366E-11 3.07519870885E-11 3.29764545235E-11 3.53598894142E-11 3.79135479038E-11 4.06494776734E-11 4.35805733182E-11 4.67206355825E-11 5.00844347233E-11 5.36877782870E-11 5.75475836085E-11 6.16819553580E-11 6.61102684890E-11 7.08532569601E-11 7.59331086331E-11 8.13735667756E-11 8.72000386268E-11 9.34397115168E-11 1.00121677064E-10 1.07277064010E-10 1.14939180293E-10 1.23143665001E-10 1.31928650888E-10 1.41334938186E-10 1.51406180499E-10 1.62189083620E-10 1.73733618153E-10 1.86093246914E-10 1.99325168130E-10 2.13490575523E-10 2.28654936463E-10 2.44888289436E-10 2.62265562158E-10 2.80866911783E-10 3.00778088722E-10 3.22090825714E-10 3.44903253900E-10 3.69320347765E-10 3.95454400955E-10 4.23425535108E-10 4.53362243972E-10 4.85401975274E-10 5.19691752941E-10 5.56388842465E-10 5.95661462415E-10 6.37689545273E-10 6.82665551019E-10 7.30795337116E-10 7.82299088794E-10 8.37412313814E-10 8.96386906165E-10 9.59492283476E-10 1.02701660324E-09 1.09926806328E-09 1.17657629237E-09 1.25929383708E-09 1.34779775174E-09 1.44249129839E-09 1.54380576460E-09 1.65220240704E-09 1.76817452975E-09 1.89224970618E-09 2.02499215523E-09 2.16700528162E-09 2.31893439222E-09 2.48146960038E-09 2.65534893125E-09 2.84136164206E-09 3.04035177214E-09 3.25322193865E-09 3.48093739490E-09 3.72453036953E-09 3.98510470587E-09 4.26384082228E-09 4.56200101559E-09 4.88093513154E-09 5.22208662723E-09 5.58699905309E-09 5.97732298307E-09 6.39482342406E-09 6.84138773782E-09 7.31903411062E-09 7.82992060858E-09 8.37635485910E-09 8.96080440168E-09 9.58590775435E-09 1.02544862451E-08 1.09695566613E-08 1.17343447735E-08 1.25522997937E-08 1.34271098338E-08 1.43627184313E-08 1.53633422182E-08 1.64334898102E-08 1.75779820019E-08 1.88019733566E-08 2.01109752895E-08 2.15108807440E-08 2.30079905745E-08 2.46090417510E-08 2.63212375130E-08 2.81522796061E-08 3.01104027456E-08 3.22044114613E-08 3.44437194864E-08 3.68383918684E-08 3.93991899875E-08 4.21376196850E-08 4.50659827154E-08 4.81974317519E-08 5.15460291909E-08 5.51268100168E-08 5.89558490083E-08 6.30503325858E-08 6.74286356184E-08 7.21104035361E-08 7.71166401100E-08 8.24698012933E-08 8.81938955413E-08 9.43145910569E-08 1.00859330440E-07 1.07857453251E-07 1.15340327035E-07 1.23341487390E-07 1.31896787704E-07 1.41044559225E-07 1.50825782182E-07 1.61284268717E-07 1.72466858433E-07 1.84423627453E-07 1.97208111890E-07 2.10877546748E-07 2.25493121309E-07 2.41120252131E-07 2.57828874899E-07 2.75693756400E-07 2.94794828029E-07 3.15217542306E-07 3.37053253978E-07 3.60399627432E-07 3.85361072190E-07 4.12049208468E-07 4.40583364830E-07 4.71091110183E-07 5.03708822459E-07 5.38582296520E-07 5.75867393991E-07 6.15730737913E-07 6.58350455296E-07 7.03916970880E-07 7.52633855639E-07 8.04718733782E-07 8.60404252303E-07 9.19939117377E-07 9.83589202211E-07 1.05163873127E-06 1.12439154615E-06 1.20217245872E-06 1.28532869750E-06 1.37423145380E-06 1.46927753441E-06 1.57089112812E-06 1.67952569410E-06 1.79566598038E-06 1.91983018134E-06 2.05257224401E-06 2.19448433317E-06 2.34619946634E-06 2.50839433028E-06 2.68179229153E-06 2.86716661436E-06 3.06534390029E-06 3.27720776463E-06 3.50370276609E-06 3.74583860708E-06 4.00469462327E-06 4.28142458217E-06 4.57726181214E-06 4.89352468455E-06 5.23162247317E-06 5.59306161697E-06 5.97945241389E-06 6.39251617524E-06 6.83409287239E-06 7.30614930959E-06 7.81078785891E-06 8.35025579611E-06 8.92695527857E-06 9.54345400929E-06 1.02024966342E-05 1.09070169231E-05 1.16601507876E-05 1.24652501938E-05 1.33258980316E-05 1.42459240045E-05 1.52294216121E-05 1.62807662978E-05 1.74046348436E-05 1.86060260960E-05 1.98902831143E-05 2.12631168394E-05 2.27306313856E-05 2.42993510682E-05 2.59762492838E-05 2.77687793707E-05 2.96849075844E-05 3.17331483326E-05 3.39226018234E-05 3.62629942920E-05 3.87647209803E-05 4.14388920576E-05 4.42973816831E-05 4.73528804218E-05 5.06189512443E-05 5.41100893512E-05 5.78417860828E-05 6.18305971921E-05 6.60942157738E-05 7.06515501662E-05 7.55228071630E-05 8.07295808901E-05 8.62949477332E-05 9.22435677213E-05 9.86017928021E-05 1.05397782470E-04 1.12661627245E-04 1.20425480517E-04 1.28723699338E-04 1.37592994726E-04 1.47072592151E-04 1.57204402851E-04 1.68033206720E-04 1.79606847510E-04 1.91976441195E-04 2.05196598329E-04 2.19325661345E-04 2.34425957766E-04 2.50564070367E-04 2.67811125401E-04 2.86243100054E-04 3.05941150390E-04 3.26991961093E-04 3.49488118421E-04 3.73528507851E-04 3.99218737994E-04 4.26671592450E-04 4.56007511360E-04 4.87355104527E-04 5.20851698078E-04 5.56643916746E-04 5.94888303973E-04 6.35751982138E-04 6.79413355369E-04 7.26062857488E-04 7.75903747784E-04 8.29152957464E-04 8.86041989721E-04 9.46817876545E-04 1.01174419552E-03 1.08110214999E-03 1.15519171609E-03 1.23433286043E-03 1.31886683200E-03 1.40915753253E-03 1.50559296909E-03 1.60858679326E-03 1.71857993112E-03 1.83604230838E-03 1.96147467510E-03 2.09541053455E-03 2.23841818060E-03 2.39110284823E-03 2.55410898154E-03 2.72812262364E-03 2.91387393267E-03 3.11213982784E-03 3.32374676937E-03 3.54957367553E-03 3.79055497996E-03 4.04768383137E-03 4.32201543757E-03 4.61467055470E-03 4.92683912154E-03 5.25978403798E-03 5.61484508501E-03 5.99344298240E-03 6.39708357844E-03 6.82736216392E-03 7.28596790054E-03 7.77468835110E-03 8.29541409598E-03 8.85014341724E-03 9.44098702763E-03 1.00701728180E-02 1.07400505919E-02 1.14530967506E-02 1.22119188869E-02 1.30192602396E-02 1.38780039527E-02 1.47911770776E-02 1.57619542481E-02 1.67936609479E-02 1.78897762831E-02 1.90539351607E-02 2.02899297650E-02 2.16017102110E-02 2.29933842447E-02 2.44692158455E-02 2.60336225778E-02 2.76911715218E-02 2.94465736075E-02 3.13046761575E-02 3.32704534419E-02 3.53489950295E-02 3.75454917203E-02 3.98652188325E-02 4.23135166167E-02 4.48957675697E-02 4.76173704241E-02 5.04837106003E-02 5.35001269230E-02 5.66718744247E-02 6.00040830923E-02 6.35017124494E-02 6.71695019191E-02 7.10119169726E-02 7.50330911409E-02 7.92367640570E-02 8.36262157935E-02 8.82041978764E-02 9.29728614835E-02 9.79336834778E-02 1.03087391077E-01 1.08433886122E-01 1.13972170063E-01 1.19700270967E-01 1.25615173963E-01 1.31712756722E-01 1.37987731622E-01 1.44433596348E-01 1.51042594626E-01 1.57805688714E-01 1.64712545061E-01 1.71751534186E-01 1.78909745323E-01 1.86173015651E-01 1.93525972983E-01 2.00952089574E-01 2.08433743216E-01 2.15952280000E-01 2.23488071025E-01 2.31020552991E-01 2.38528240009E-01 2.45988691303E-01 2.53378416774E-01 2.60672700009E-01 2.67845316453E-01 2.74868123573E-01 2.81710500423E-01 2.88338616736E-01 2.94714517275E-01 3.00795016578E-01 3.06530413378E-01 3.11863053949E-01 3.16725800291E-01 3.21040493195E-01 3.24716542069E-01 3.27649822466E-01 3.29722116701E-01 3.30801389408E-01 3.30743241991E-01 3.29393928486E-01 3.26595326224E-01 3.22192219046E-01 3.16042143415E-01 3.08027837980E-01 2.98071989770E-01 2.86153449650E-01 2.72323369458E-01 2.56718790455E-01 2.39570138747E-01 2.21198008954E-01 2.01993873015E-01 1.82379566926E-01 1.62742712689E-01 1.43351540754E-01 1.24266055727E-01 1.05288219943E-01 8.60398481164E-02 6.62866916469E-02 4.60767050570E-02 2.55028063630E-02 4.66772766814E-03 -1.63161201490E-02 -3.73269058125E-02 -5.82338570294E-02 -7.88980116056E-02 -9.91732854705E-02 -1.18907907114E-01 -1.37946257935E-01 -1.56131132621E-01 -1.73306401253E-01 -1.89319974537E-01 -2.04026905555E-01 -2.17292333805E-01 -2.28993932369E-01 -2.39023463843E-01 -2.47287201463E-01 -2.53705149406E-01 -2.58209381389E-01 -2.60742046097E-01 -2.61253799575E-01 -2.59703245562E-01 -2.56057749799E-01 -2.50295588521E-01 -2.42409301735E-01 -2.32410132565E-01 -2.20333800209E-01 -2.06248149638E-01 -1.90263514214E-01 -1.72546561646E-01 -1.53337993086E-01 -1.32973461355E-01 -1.11905302151E-01 -9.07198210496E-02 -7.01405547348E-02 -5.10017826540E-02 -3.41699019387E-02 -2.04211266989E-02 -1.03032953799E-02 -3.95009091861E-03 -9.00931736086E-04 -5.22875044877E-05 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 9.07374500694E+00 -5.83807001398E+00 -2.12887897438E+02 1.06793978572E+03 -2.46379898602E+03 3.05587894722E+03 -1.96215773952E+03 5.12095769878E+02 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 3 3 1 i j (l(j)) -3.63455564913E-01 Q_int 0.00000000000E+00 6.70617905690E-13 2.72774354470E-12 6.24129284109E-12 1.12839367291E-11 1.79312010079E-11 2.62615696910E-11 3.63565919673E-11 4.83009929021E-11 6.21827880030E-11 7.80934017879E-11 9.61277904846E-11 1.16384569018E-10 1.38966142417E-10 1.63978841800E-10 1.91533065099E-10 2.21743422685E-10 2.54728888050E-10 2.90612953738E-10 3.29523792694E-10 3.71594425218E-10 4.16962891720E-10 4.65772431468E-10 5.18171667546E-10 5.74314798231E-10 6.34361794976E-10 6.98478607300E-10 7.66837374753E-10 8.39616646225E-10 9.17001606837E-10 9.99184312702E-10 1.08636393383E-09 1.17874700536E-09 1.27654768753E-09 1.37998803470E-09 1.48929827347E-09 1.60471709065E-09 1.72649193103E-09 1.85487930533E-09 1.99014510910E-09 2.13256495223E-09 2.28242450018E-09 2.44001982668E-09 2.60565777875E-09 2.77965635430E-09 2.96234509267E-09 3.15406547860E-09 3.35517136026E-09 3.56602938147E-09 3.78701942892E-09 4.01853509474E-09 4.26098415500E-09 4.51478906464E-09 4.78038746937E-09 5.05823273508E-09 5.34879449608E-09 5.65255922105E-09 5.97003079933E-09 6.30173114700E-09 6.64820083399E-09 7.00999973216E-09 7.38770768636E-09 7.78192520798E-09 8.19327419250E-09 8.62239866146E-09 9.06996553039E-09 9.53666540219E-09 1.00232133885E-08 1.05303499592E-08 1.10588418198E-08 1.16094828210E-08 1.21830948971E-08 1.27805290388E-08 1.34026662968E-08 1.40504188224E-08 1.47247309419E-08 1.54265802678E-08 1.61569788494E-08 1.69169743616E-08 1.77076513340E-08 1.85301324237E-08 1.93855797294E-08 2.02751961531E-08 2.12002268051E-08 2.21619604607E-08 2.31617310625E-08 2.42009192787E-08 2.52809541104E-08 2.64033145563E-08 2.75695313338E-08 2.87811886582E-08 3.00399260830E-08 3.13474404045E-08 3.27054876279E-08 3.41158850039E-08 3.55805131333E-08 3.71013181452E-08 3.86803139440E-08 4.03195845424E-08 4.20212864640E-08 4.37876512351E-08 4.56209879581E-08 4.75236859730E-08 4.94982176117E-08 5.15471410428E-08 5.36731032154E-08 5.58788429041E-08 5.81671938563E-08 6.05410880456E-08 6.30035590413E-08 6.55577454838E-08 6.82068946899E-08 7.09543663684E-08 7.38036364729E-08 7.67583011793E-08 7.98220810040E-08 8.29988250527E-08 8.62925154294E-08 8.97072717796E-08 9.32473559976E-08 9.69171770927E-08 1.00721296217E-07 1.04664431871E-07 1.08751465282E-07 1.12987445961E-07 1.17377597462E-07 1.21927323324E-07 1.26642213221E-07 1.31528049324E-07 1.36590812871E-07 1.41836690967E-07 1.47272083618E-07 1.52903610998E-07 1.58738120960E-07 1.64782696814E-07 1.71044665363E-07 1.77531605209E-07 1.84251355345E-07 1.91212024045E-07 1.98421998040E-07 2.05889952029E-07 2.13624858488E-07 2.21635997832E-07 2.29932968910E-07 2.38525699878E-07 2.47424459395E-07 2.56639868256E-07 2.66182911391E-07 2.76064950261E-07 2.86297735703E-07 2.96893421190E-07 3.07864576548E-07 3.19224202147E-07 3.30985743564E-07 3.43163106733E-07 3.55770673650E-07 3.68823318564E-07 3.82336424736E-07 3.96325901793E-07 4.10808203622E-07 4.25800346908E-07 4.41319930299E-07 4.57385154196E-07 4.74014841240E-07 4.91228457491E-07 5.09046134323E-07 5.27488691043E-07 5.46577658306E-07 5.66335302335E-07 5.86784649889E-07 6.07949514183E-07 6.29854521616E-07 6.52525139406E-07 6.75987704211E-07 7.00269451662E-07 7.25398546979E-07 7.51404116488E-07 7.78316280372E-07 8.06166186429E-07 8.34986044955E-07 8.64809164920E-07 8.95669991265E-07 9.27604143496E-07 9.60648455650E-07 9.94841017452E-07 1.03022121708E-06 1.06682978522E-06 1.10470884068E-06 1.14390193752E-06 1.18445411381E-06 1.22641194203E-06 1.26982358116E-06 1.31473883055E-06 1.36120918561E-06 1.40928789542E-06 1.45903002219E-06 1.51049250289E-06 1.56373421279E-06 1.61881603130E-06 1.67580090998E-06 1.73475394279E-06 1.79574243888E-06 1.85883599764E-06 1.92410658645E-06 1.99162862100E-06 2.06147904831E-06 2.13373743255E-06 2.20848604391E-06 2.28580995018E-06 2.36579711172E-06 2.44853847954E-06 2.53412809656E-06 2.62266320255E-06 2.71424434235E-06 2.80897547797E-06 2.90696410432E-06 3.00832136891E-06 3.11316219572E-06 3.22160541282E-06 3.33377388497E-06 3.44979465006E-06 3.56979906055E-06 3.69392292951E-06 3.82230668164E-06 3.95509550940E-06 4.09243953430E-06 4.23449397376E-06 4.38141931366E-06 4.53338148624E-06 4.69055205479E-06 4.85310840369E-06 5.02123393561E-06 5.19511827475E-06 5.37495747731E-06 5.56095424879E-06 5.75331816898E-06 5.95226592388E-06 6.15802154604E-06 6.37081666266E-06 6.59089075203E-06 6.81849140867E-06 7.05387461761E-06 7.29730503687E-06 7.54905629100E-06 7.80941127309E-06 8.07866245740E-06 8.35711222301E-06 8.64507318708E-06 8.94286855042E-06 9.25083245406E-06 9.56931034778E-06 9.89865937124E-06 1.02392487474E-05 1.05914601893E-05 1.09556883206E-05 1.13323411102E-05 1.17218403203E-05 1.21246219712E-05 1.25411368199E-05 1.29718508553E-05 1.34172458109E-05 1.38778196917E-05 1.43540873221E-05 1.48465809090E-05 1.53558506261E-05 1.58824652152E-05 1.64270126089E-05 1.69901005736E-05 1.75723573737E-05 1.81744324572E-05 1.87969971647E-05 1.94407454619E-05 2.01063946947E-05 2.07946863708E-05 2.15063869663E-05 2.22422887590E-05 2.30032106883E-05 2.37899992431E-05 2.46035293816E-05 2.54447054765E-05 2.63144622942E-05 2.72137660059E-05 2.81436152289E-05 2.91050421059E-05 3.00991134138E-05 3.11269317143E-05 3.21896365371E-05 3.32884056031E-05 3.44244560876E-05 3.55990459216E-05 3.68134751391E-05 3.80690872613E-05 3.93672707301E-05 4.07094603881E-05 4.20971389982E-05 4.35318388200E-05 4.50151432303E-05 4.65486883991E-05 4.81341650121E-05 4.97733200538E-05 5.14679586420E-05 5.32199459235E-05 5.50312090214E-05 5.69037390518E-05 5.88395931961E-05 6.08408968386E-05 6.29098457715E-05 6.50487084669E-05 6.72598284110E-05 6.95456265204E-05 7.19086036225E-05 7.43513430134E-05 7.68765130909E-05 7.94868700659E-05 8.21852607532E-05 8.49746254490E-05 8.78580008810E-05 9.08385232560E-05 9.39194313917E-05 9.71040699270E-05 1.00395892644E-04 1.03798465865E-04 1.07315471954E-04 1.10950712908E-04 1.14708114060E-04 1.18591727865E-04 1.22605737799E-04 1.26754462360E-04 1.31042359173E-04 1.35474029205E-04 1.40054221077E-04 1.44787835498E-04 1.49679929806E-04 1.54735722620E-04 1.59960598594E-04 1.65360113307E-04 1.70939998242E-04 1.76706165899E-04 1.82664714997E-04 1.88821935828E-04 1.95184315677E-04 2.01758544405E-04 2.08551520091E-04 2.15570354823E-04 2.22822380586E-04 2.30315155252E-04 2.38056468662E-04 2.46054348833E-04 2.54317068238E-04 2.62853150188E-04 2.71671375290E-04 2.80780788000E-04 2.90190703220E-04 2.99910712994E-04 3.09950693234E-04 3.20320810505E-04 3.31031528837E-04 3.42093616556E-04 3.53518153146E-04 3.65316536090E-04 3.77500487665E-04 3.90082061759E-04 4.03073650559E-04 4.16487991219E-04 4.30338172341E-04 4.44637640461E-04 4.59400206198E-04 4.74640050365E-04 4.90371729764E-04 5.06610182765E-04 5.23370734566E-04 5.40669102088E-04 5.58521398511E-04 5.76944137359E-04 5.95954236058E-04 6.15569018977E-04 6.35806219796E-04 6.56683983213E-04 6.78220865865E-04 7.00435836441E-04 7.23348274703E-04 7.46977969708E-04 7.71345116646E-04 7.96470312611E-04 8.22374550898E-04 8.49079213767E-04 8.76606063724E-04 9.04977232840E-04 9.34215210199E-04 9.64342827209E-04 9.95383240652E-04 1.02735991309E-03 1.06029659073E-03 1.09421727817E-03 1.12914621005E-03 1.16510781922E-03 1.20212670107E-03 1.24022757403E-03 1.27943523536E-03 1.31977451254E-03 1.36127020932E-03 1.40394704648E-03 1.44782959640E-03 1.49294221143E-03 1.53930894540E-03 1.58695346758E-03 1.63589896875E-03 1.68616805878E-03 1.73778265480E-03 1.79076385975E-03 1.84513183005E-03 1.90090563205E-03 1.95810308614E-03 2.01674059785E-03 2.07683297469E-03 2.13839322817E-03 2.20143235944E-03 2.26595912771E-03 2.33197980021E-03 2.39949788220E-03 2.46851382590E-03 2.53902471658E-03 2.61102393466E-03 2.68450079157E-03 2.75944013815E-03 2.83582194340E-03 2.91362084181E-03 2.99280564659E-03 3.07333882758E-03 3.15517595035E-03 3.23826507460E-03 3.32254610915E-03 3.40795012048E-03 3.49439859167E-03 3.58180262944E-03 3.67006211440E-03 3.75906479287E-03 3.84868530466E-03 3.93878414414E-03 4.02920655016E-03 4.11978131992E-03 4.21031954300E-03 4.30061325002E-03 4.39043397135E-03 4.47953119982E-03 4.56763075338E-03 4.65443302944E-03 4.73961114736E-03 4.82280897087E-03 4.90363900491E-03 4.98168015887E-03 5.05647537028E-03 5.12752908091E-03 5.19430455717E-03 5.25622104781E-03 5.31265077008E-03 5.36291571604E-03 5.40628427119E-03 5.44196763532E-03 5.46911603846E-03 5.48681474045E-03 5.49407980936E-03 5.48985366464E-03 5.47300037999E-03 5.44230073604E-03 5.39644701329E-03 5.33403751994E-03 5.25357084258E-03 5.15343981793E-03 5.03192521472E-03 4.88718912377E-03 4.71726804894E-03 4.52006569886E-03 4.29334547631E-03 4.03472266580E-03 3.74165632333E-03 3.41144087114E-03 3.04119740804E-03 2.62786474461E-03 2.16819017897E-03 1.65872003238E-03 1.09578996836E-03 4.75515126348E-04 -2.06219899137E-04 -9.53771185077E-04 -1.77174566863E-03 -2.66501133605E-03 -3.63870734601E-03 -4.69825401185E-03 -5.84936254706E-03 -7.09804448461E-03 -8.45062064326E-03 -9.91372952321E-03 -1.14943349790E-02 -1.31997330113E-02 -1.50375574997E-02 -1.70157846729E-02 -1.91427361054E-02 -2.14270799865E-02 -2.38778304154E-02 -2.65043444168E-02 -2.93163163814E-02 -3.23237695851E-02 -3.55370444290E-02 -3.89667830190E-02 -4.26239096646E-02 -4.65196068814E-02 -5.06652864278E-02 -5.50725549168E-02 -5.97531735178E-02 -6.47190112468E-02 -6.99819913596E-02 -7.55540303486E-02 -8.14469690633E-02 -8.76724955070E-02 -9.42420588825E-02 -1.01166774526E-01 -1.08457319428E-01 -1.16123818134E-01 -1.24175718911E-01 -1.32621660221E-01 -1.41469327679E-01 -1.50725301865E-01 -1.60394897567E-01 -1.70481995287E-01 -1.80988866070E-01 -1.91915991071E-01 -2.03261877519E-01 -2.15022873122E-01 -2.27192981275E-01 -2.39763679763E-01 -2.52723745977E-01 -2.66059091937E-01 -2.79752612632E-01 -2.93784051300E-01 -3.08129885293E-01 -3.22763235965E-01 -3.37653805671E-01 -3.52767844276E-01 -3.68068146637E-01 -3.83514081146E-01 -3.99061647684E-01 -4.14663561071E-01 -4.30269353443E-01 -4.45825485738E-01 -4.61275454950E-01 -4.76559879874E-01 -4.91616544126E-01 -5.06380371522E-01 -5.20783305902E-01 -5.34754065969E-01 -5.48217746489E-01 -5.61095241523E-01 -5.73302474689E-01 -5.84749437660E-01 -5.95339063151E-01 -6.04965995021E-01 -6.13515367740E-01 -6.20861772612E-01 -6.26868668952E-01 -6.31388594087E-01 -6.34264630525E-01 -6.35333690932E-01 -6.34432258691E-01 -6.31405236031E-01 -6.26118440226E-01 -6.18474950949E-01 -6.08434795767E-01 -5.96036132419E-01 -5.81413799883E-01 -5.64807353618E-01 -5.46544732813E-01 -5.26978454902E-01 -5.06355143804E-01 -4.84800088173E-01 -4.62431804304E-01 -4.39375781987E-01 -4.15763424511E-01 -3.91730761215E-01 -3.67416976366E-01 -3.42962810379E-01 -3.18508828666E-01 -2.94193658022E-01 -2.70152230883E-01 -2.46514202509E-01 -2.23402641577E-01 -2.00933212530E-01 -1.79213956314E-01 -1.58345815190E-01 -1.38423816018E-01 -1.19538732424E-01 -1.01778732003E-01 -8.52304440833E-02 -6.99787751337E-02 -5.61050535095E-02 -4.36833402395E-02 -3.27751713658E-02 -2.34231858489E-02 -1.56441992056E-02 -9.42216447699E-03 -4.70143880759E-03 -1.38088597479E-03 6.90221221038E-04 1.71287441472E-03 1.93317012068E-03 1.62830812523E-03 1.08081697613E-03 5.39743217836E-04 1.72394280349E-04 2.10142338242E-05 8.32975074352E-08 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 5.59639254461E-01 -1.48694640784E+01 3.06934533342E+01 2.60169094189E+01 -1.98167320973E+02 3.36327059111E+02 -2.55708448831E+02 7.48549738476E+01 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 -1.43725797059E+01 4.27087515802E+01 -3.37261782047E+01 -8.18233534553E+01 2.69672154582E+02 -3.41754329203E+02 2.10836045877E+02 -5.19340920813E+01 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 3 4 1 i j (l(j)) 1.13383024021E-01 Q_int 0.00000000000E+00 5.51230610730E-12 2.24213479453E-11 5.13018163713E-11 9.27510477189E-11 1.47389844583E-10 2.15863325318E-10 2.98841803239E-10 3.97021696554E-10 5.11126470068E-10 6.41907609770E-10 7.90145631428E-10 9.56651124346E-10 1.14226583152E-09 1.34786376742E-09 1.57435237470E-09 1.82267372115E-09 2.09380573837E-09 2.38876350337E-09 2.70860056493E-09 3.05441031583E-09 3.42732741291E-09 3.82852924633E-09 4.25923745985E-09 4.72071952387E-09 5.21429036296E-09 5.74131403990E-09 6.30320549791E-09 6.90143236340E-09 7.53751681104E-09 8.21303749338E-09 8.92963153724E-09 9.68899660919E-09 1.04928930524E-08 1.13431460973E-08 1.22416481488E-08 1.31903611523E-08 1.41913190413E-08 1.52466302700E-08 1.63584804329E-08 1.75291349746E-08 1.87609419935E-08 2.00563351420E-08 2.14178366262E-08 2.28480603101E-08 2.43497149253E-08 2.59256073921E-08 2.75786462550E-08 2.93118452362E-08 3.11283269112E-08 3.30313265110E-08 3.50241958553E-08 3.71104074208E-08 3.92935585490E-08 4.15773757996E-08 4.39657194516E-08 4.64625881614E-08 4.90721237791E-08 5.17986163312E-08 5.46465091731E-08 5.76204043204E-08 6.07250679611E-08 6.39654361584E-08 6.73466207479E-08 7.08739154387E-08 7.45528021214E-08 7.83889573947E-08 8.23882593140E-08 8.65567943715E-08 9.09008647173E-08 9.54269956241E-08 1.00141943212E-07 1.05052702434E-07 1.10166515337E-07 1.15490879607E-07 1.21033557400E-07 1.26802584487E-07 1.32806279697E-07 1.39053254698E-07 1.45552424101E-07 1.52313015915E-07 1.59344582358E-07 1.66657011042E-07 1.74260536530E-07 1.82165752299E-07 1.90383623106E-07 1.98925497778E-07 2.07803122437E-07 2.17028654182E-07 2.26614675231E-07 2.36574207552E-07 2.46920727994E-07 2.57668183924E-07 2.68831009414E-07 2.80424141969E-07 2.92463039830E-07 3.04963699863E-07 3.17942676071E-07 3.31417098717E-07 3.45404694122E-07 3.59923805122E-07 3.74993412228E-07 3.90633155512E-07 4.06863357228E-07 4.23705045219E-07 4.41179977110E-07 4.59310665334E-07 4.78120403001E-07 4.97633290663E-07 5.17874263975E-07 5.38869122317E-07 5.60644558368E-07 5.83228188713E-07 6.06648585475E-07 6.30935309029E-07 6.56118941830E-07 6.82231123405E-07 7.09304586509E-07 7.37373194545E-07 7.66471980234E-07 7.96637185612E-07 8.27906303391E-07 8.60318119717E-07 8.93912758396E-07 9.28731726621E-07 9.64817962249E-07 1.00221588269E-06 1.04097143549E-06 1.08113215055E-06 1.12274719425E-06 1.16586742527E-06 1.21054545247E-06 1.25683569455E-06 1.30479444194E-06 1.35447992064E-06 1.40595235831E-06 1.45927405256E-06 1.51450944164E-06 1.57172517745E-06 1.63099020104E-06 1.69237582077E-06 1.75595579301E-06 1.82180640566E-06 1.89000656445E-06 1.96063788225E-06 2.03378477136E-06 2.10953453895E-06 2.18797748572E-06 2.26920700800E-06 2.35331970318E-06 2.44041547888E-06 2.53059766568E-06 2.62397313382E-06 2.72065241376E-06 2.82074982086E-06 2.92438358436E-06 3.03167598064E-06 3.14275347112E-06 3.25774684473E-06 3.37679136530E-06 3.50002692394E-06 3.62759819657E-06 3.75965480685E-06 3.89635149457E-06 4.03784828985E-06 4.18431069316E-06 4.33590986154E-06 4.49282280112E-06 4.65523256608E-06 4.82332846458E-06 4.99730627146E-06 5.17736844825E-06 5.36372437074E-06 5.55659056409E-06 5.75619094614E-06 5.96275707871E-06 6.17652842776E-06 6.39775263207E-06 6.62668578125E-06 6.86359270312E-06 7.10874726079E-06 7.36243265990E-06 7.62494176631E-06 7.89657743441E-06 8.17765284683E-06 8.46849186541E-06 8.76942939428E-06 9.08081175517E-06 9.40299707547E-06 9.73635568946E-06 1.00812705532E-05 1.04381376732E-05 1.08073665505E-05 1.11893806385E-05 1.15846178174E-05 1.19935308843E-05 1.24165880600E-05 1.28542735129E-05 1.33070879011E-05 1.37755489318E-05 1.42601919413E-05 1.47615704932E-05 1.52802569976E-05 1.58168433513E-05 1.63719415996E-05 1.69461846203E-05 1.75402268316E-05 1.81547449227E-05 1.87904386112E-05 1.94480314238E-05 2.01282715056E-05 2.08319324553E-05 2.15598141896E-05 2.23127438366E-05 2.30915766595E-05 2.38971970116E-05 2.47305193239E-05 2.55924891254E-05 2.64840840995E-05 2.74063151744E-05 2.83602276519E-05 2.93469023737E-05 3.03674569272E-05 3.14230468927E-05 3.25148671325E-05 3.36441531235E-05 3.48121823354E-05 3.60202756553E-05 3.72697988607E-05 3.85621641421E-05 3.98988316778E-05 4.12813112613E-05 4.27111639845E-05 4.41900039772E-05 4.57195002067E-05 4.73013783365E-05 4.89374226499E-05 5.06294780374E-05 5.23794520520E-05 5.41893170337E-05 5.60611123067E-05 5.79969464494E-05 5.99989996439E-05 6.20695261016E-05 6.42108565741E-05 6.64254009470E-05 6.87156509221E-05 7.10841827908E-05 7.35336603008E-05 7.60668376198E-05 7.86865623996E-05 8.13957789441E-05 8.41975314838E-05 8.70949675618E-05 9.00913415338E-05 9.31900181861E-05 9.63944764774E-05 9.97083134050E-05 1.03135248003E-04 1.06679125477E-04 1.10343921473E-04 1.14133746498E-04 1.18052850488E-04 1.22105627521E-04 1.26296620706E-04 1.30630527220E-04 1.35112203532E-04 1.39746670783E-04 1.44539120370E-04 1.49494919700E-04 1.54619618150E-04 1.59918953219E-04 1.65398856899E-04 1.71065462247E-04 1.76925110190E-04 1.82984356553E-04 1.89249979327E-04 1.95728986182E-04 2.02428622228E-04 2.09356378046E-04 2.16519997982E-04 2.23927488723E-04 2.31587128165E-04 2.39507474569E-04 2.47697376044E-04 2.56165980322E-04 2.64922744890E-04 2.73977447443E-04 2.83340196694E-04 2.93021443552E-04 3.03031992665E-04 3.13383014363E-04 3.24086056993E-04 3.35153059665E-04 3.46596365441E-04 3.58428734946E-04 3.70663360452E-04 3.83313880418E-04 3.96394394538E-04 4.09919479268E-04 4.23904203893E-04 4.38364147113E-04 4.53315414206E-04 4.68774654738E-04 4.84759080886E-04 5.01286486364E-04 5.18375265972E-04 5.36044435811E-04 5.54313654169E-04 5.73203243087E-04 5.92734210663E-04 6.12928274084E-04 6.33807883428E-04 6.55396246256E-04 6.77717353022E-04 7.00796003318E-04 7.24657832997E-04 7.49329342191E-04 7.74837924245E-04 8.01211895635E-04 8.28480526837E-04 8.56674074240E-04 8.85823813103E-04 9.15962071599E-04 9.47122265969E-04 9.79338936842E-04 1.01264778675E-03 1.04708571884E-03 1.08269087690E-03 1.11950268668E-03 1.15756189853E-03 1.19691063145E-03 1.23759241860E-03 1.27965225423E-03 1.32313664223E-03 1.36809364611E-03 1.41457294074E-03 1.46262586569E-03 1.51230548029E-03 1.56366662048E-03 1.61676595747E-03 1.67166205830E-03 1.72841544836E-03 1.78708867582E-03 1.84774637822E-03 1.91045535107E-03 1.97528461876E-03 2.04230550756E-03 2.11159172106E-03 2.18321941788E-03 2.25726729191E-03 2.33381665496E-03 2.41295152210E-03 2.49475869957E-03 2.57932787543E-03 2.66675171307E-03 2.75712594752E-03 2.85054948479E-03 2.94712450415E-03 3.04695656360E-03 3.15015470859E-03 3.25683158382E-03 3.36710354863E-03 3.48109079567E-03 3.59891747326E-03 3.72071181111E-03 3.84660625012E-03 3.97673757560E-03 4.11124705461E-03 4.25028057718E-03 4.39398880157E-03 4.54252730374E-03 4.69605673103E-03 4.85474296004E-03 5.01875725913E-03 5.18827645521E-03 5.36348310522E-03 5.54456567222E-03 5.73171870621E-03 5.92514302970E-03 6.12504592839E-03 6.33164134641E-03 6.54515008700E-03 6.76580001793E-03 6.99382628223E-03 7.22947151417E-03 7.47298606019E-03 7.72462820537E-03 7.98466440508E-03 8.25336952198E-03 8.53102706820E-03 8.81792945312E-03 9.11437823611E-03 9.42068438491E-03 9.73716853887E-03 1.00641612777E-02 1.04020033952E-02 1.07510461777E-02 1.11116516881E-02 1.14841930540E-02 1.18690547605E-02 1.22666329481E-02 1.26773357135E-02 1.31015834158E-02 1.35398089854E-02 1.39924582362E-02 1.44599901816E-02 1.49428773521E-02 1.54416061160E-02 1.59566770005E-02 1.64886050155E-02 1.70379199762E-02 1.76051668272E-02 1.81909059638E-02 1.87957135537E-02 1.94201818543E-02 2.00649195274E-02 2.07305519494E-02 2.14177215151E-02 2.21270879352E-02 2.28593285250E-02 2.36151384839E-02 2.43952311631E-02 2.52003383203E-02 2.60312103602E-02 2.68886165570E-02 2.77733452588E-02 2.86862040710E-02 2.96280200144E-02 3.05996396590E-02 3.16019292267E-02 3.26357746624E-02 3.37020816701E-02 3.48017757086E-02 3.59358019450E-02 3.71051251617E-02 3.83107296110E-02 3.95536188146E-02 4.08348153031E-02 4.21553602877E-02 4.35163132623E-02 4.49187515271E-02 4.63637696288E-02 4.78524787108E-02 4.93860057660E-02 5.09654927837E-02 5.25920957854E-02 5.42669837383E-02 5.59913373390E-02 5.77663476580E-02 5.95932146347E-02 6.14731454135E-02 6.34073525083E-02 6.53970517861E-02 6.74434602564E-02 6.95477936535E-02 7.17112638002E-02 7.39350757367E-02 7.62204246034E-02 7.85684922592E-02 8.09804436249E-02 8.34574227279E-02 8.60005484410E-02 8.86109098910E-02 9.12895615227E-02 9.40375178006E-02 9.68557475275E-02 9.97451677658E-02 1.02706637338E-01 1.05740949889E-01 1.08848826495E-01 1.12030907790E-01 1.15287745608E-01 1.18619794099E-01 1.22027400329E-01 1.25510794319E-01 1.29070078533E-01 1.32705216774E-01 1.36416022505E-01 1.40202146553E-01 1.44063064211E-01 1.47998061723E-01 1.52006222141E-01 1.56086410574E-01 1.60237258816E-01 1.64457149373E-01 1.68744198901E-01 1.73096241075E-01 1.77510808928E-01 1.81985116680E-01 1.86516041117E-01 1.91100102564E-01 1.95733445530E-01 2.00411819094E-01 2.05130557113E-01 2.09884558388E-01 2.14668266861E-01 2.19475652031E-01 2.24300189687E-01 2.29134843189E-01 2.33972045426E-01 2.38803681720E-01 2.43621073875E-01 2.48414965633E-01 2.53175509838E-01 2.57892257576E-01 2.62554149656E-01 2.67149510754E-01 2.71666046600E-01 2.76090844625E-01 2.80410378442E-01 2.84610516625E-01 2.88676536222E-01 2.92593141441E-01 2.96344487996E-01 2.99914213532E-01 3.03285474606E-01 3.06440990630E-01 3.09363095175E-01 3.12033794996E-01 3.14434837067E-01 3.16547783856E-01 3.18354096994E-01 3.19835229360E-01 3.20972725520E-01 3.21748330287E-01 3.22144105049E-01 3.22142551301E-01 3.21726740670E-01 3.20880450511E-01 3.19588303958E-01 3.17835913108E-01 3.15610023876E-01 3.12898660850E-01 3.09691270405E-01 3.05978860253E-01 3.01754133665E-01 2.97011616688E-01 2.91747776986E-01 2.85961133344E-01 2.79652355471E-01 2.72824354614E-01 2.65482366505E-01 2.57634029561E-01 2.49289462724E-01 2.40461349228E-01 2.31165034415E-01 2.21418647767E-01 2.11243261167E-01 2.00663096847E-01 1.89705799242E-01 1.78402784450E-01 1.66789678654E-01 1.54906851874E-01 1.42800044851E-01 1.30521073501E-01 1.18128576314E-01 1.05688743661E-01 9.32759338142E-02 8.09730376646E-02 6.88714039845E-02 5.70700818906E-02 4.56740839896E-02 3.47913335480E-02 2.45279529097E-02 1.49816119751E-02 6.23283681266E-03 -1.66543723936E-03 -8.69907385042E-03 -1.49024901041E-02 -2.03627400296E-02 -2.52105297765E-02 -2.95858413590E-02 -3.35680394783E-02 -3.71685191272E-02 -4.03931757585E-02 -4.32503526046E-02 -4.57508248417E-02 -4.79076839119E-02 -4.97361520766E-02 -5.12532780217E-02 -5.24774950871E-02 -5.34279792108E-02 -5.41237777143E-02 -5.45826547336E-02 -5.48196552309E-02 -5.48454167941E-02 -5.46643639181E-02 -5.42730181048E-02 -5.36587824490E-02 -5.27996363220E-02 -5.16651462582E-02 -5.02190501369E-02 -4.84233527460E-02 -4.62435645567E-02 -4.36544394048E-02 -4.06455889909E-02 -3.72264988759E-02 -3.34308051214E-02 -2.93197975547E-02 -2.49850561500E-02 -2.05496587823E-02 -1.61668290353E-02 -1.20142133574E-02 -8.28156199167E-03 -5.14961756189E-03 -2.75906375464E-03 -1.17128549570E-03 -3.28907783271E-04 -3.60811426899E-05 -1.08382700313E-07 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 4.60009023620E+00 -2.20943254608E+01 4.02144571404E+01 -1.28630181562E+01 -8.44865560664E+01 1.67669939452E+02 -1.32283503840E+02 3.92426113840E+01 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 5.40400152682E+00 4.09907879640E+01 -5.88491717615E+02 2.61711545413E+03 -5.92630113534E+03 7.33628616201E+03 -4.71925719086E+03 1.23507823462E+03 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 3 5 2 i j (l(j)) 0.00000000000E+00 Q_int 0.00000000000E+00 -3.20510743864E-18 -2.62926996061E-17 -9.10000675948E-17 -2.21218191899E-16 -4.43143051097E-16 -7.85436169331E-16 -1.27939492806E-15 -1.95913319632E-15 -2.86177286386E-15 -4.02764689369E-15 -5.50051454370E-15 -7.32778944286E-15 -9.56078124426E-15 -1.22549516170E-14 -1.54701853800E-14 -1.92710776233E-14 -2.37272377115E-14 -2.89136111072E-14 -3.49108200076E-14 -4.18055238388E-14 -4.96908007093E-14 -5.86665509820E-14 -6.88399241897E-14 -8.03257705812E-14 -9.32471186566E-14 -1.07735680123E-13 -1.23932383779E-13 -1.41987939911E-13 -1.62063436885E-13 -1.84330971688E-13 -2.08974316278E-13 -2.36189621701E-13 -2.66186162039E-13 -2.99187120348E-13 -3.35430418886E-13 -3.75169596035E-13 -4.18674732445E-13 -4.66233429087E-13 -5.18151840011E-13 -5.74755762790E-13 -6.36391789753E-13 -7.03428523305E-13 -7.76257858786E-13 -8.55296338523E-13 -9.40986580893E-13 -1.03379878846E-12 -1.13423233940E-12 -1.24281746677E-12 -1.36011703022E-12 -1.48672838524E-12 -1.62328535500E-12 -1.77046031055E-12 -1.92896636484E-12 -2.09955968692E-12 -2.28304194261E-12 -2.48026286847E-12 -2.69212298605E-12 -2.91957646411E-12 -3.16363413646E-12 -3.42536668391E-12 -3.70590798893E-12 -4.00645867228E-12 -4.32828982123E-12 -4.67274691958E-12 -5.04125399016E-12 -5.43531796115E-12 -5.85653326798E-12 -6.30658670338E-12 -6.78726252868E-12 -7.30044786019E-12 -7.84813834522E-12 -8.43244414306E-12 -9.05559622699E-12 -9.71995302431E-12 -1.04280074122E-11 -1.11823940883E-11 -1.19858973355E-11 -1.28414592021E-11 -1.37521881187E-11 -1.47213679755E-11 -1.57524676836E-11 -1.68491512460E-11 -1.80152883653E-11 -1.92549656160E-11 -2.05724982113E-11 -2.19724423951E-11 -2.34596084930E-11 -2.50390746561E-11 -2.67162013338E-11 -2.84966465146E-11 -3.03863817743E-11 -3.23917091748E-11 -3.45192790569E-11 -3.67761087750E-11 -3.91696024225E-11 -4.17075715996E-11 -4.43982572780E-11 -4.72503528202E-11 -5.02730282140E-11 -5.34759555841E-11 -5.68693360497E-11 -6.04639279964E-11 -6.42710768382E-11 -6.83027463447E-11 -7.25715516182E-11 -7.70907938044E-11 -8.18744966277E-11 -8.69374448472E-11 -9.22952247315E-11 -9.79642666599E-11 -1.03961889958E-10 -1.10306350087E-10 -1.17016888306E-10 -1.24113783937E-10 -1.31618409375E-10 -1.39553287968E-10 -1.47942154937E-10 -1.56810021483E-10 -1.66183242246E-10 -1.76089586290E-10 -1.86558311811E-10 -1.97620244732E-10 -2.09307861425E-10 -2.21655375733E-10 -2.34698830557E-10 -2.48476194207E-10 -2.63027461789E-10 -2.78394761884E-10 -2.94622468784E-10 -3.11757320580E-10 -3.29848543417E-10 -3.48947982206E-10 -3.69110238161E-10 -3.90392813488E-10 -4.12856263615E-10 -4.36564357343E-10 -4.61584245330E-10 -4.87986637343E-10 -5.15845988729E-10 -5.45240696581E-10 -5.76253306103E-10 -6.08970727705E-10 -6.43484465373E-10 -6.79890856905E-10 -7.18291326629E-10 -7.58792651240E-10 -8.01507239437E-10 -8.46553426084E-10 -8.94055781627E-10 -9.44145437566E-10 -9.96960428821E-10 -1.05264605384E-09 -1.11135525339E-09 -1.17324900898E-09 -1.23849676195E-09 -1.30727685426E-09 -1.37977699211E-09 -1.45619473364E-09 -1.53673800180E-09 -1.62162562384E-09 -1.71108789874E-09 -1.80536719400E-09 -1.90471857325E-09 -2.00941045652E-09 -2.11972531446E-09 -2.23596039866E-09 -2.35842850961E-09 -2.48745880449E-09 -2.62339764664E-09 -2.76660949904E-09 -2.91747786389E-09 -3.07640627084E-09 -3.24381931628E-09 -3.42016375625E-09 -3.60590965595E-09 -3.80155159856E-09 -4.00760995652E-09 -4.22463222846E-09 -4.45319444518E-09 -4.69390264829E-09 -4.94739444504E-09 -5.21434064362E-09 -5.49544697268E-09 -5.79145588974E-09 -6.10314848284E-09 -6.43134647034E-09 -6.77691430395E-09 -7.14076138015E-09 -7.52384436577E-09 -7.92716964350E-09 -8.35179588349E-09 -8.79883674758E-09 -9.26946373299E-09 -9.76490916260E-09 -1.02864693294E-08 -1.08355078028E-08 -1.14134589061E-08 -1.20218313721E-08 -1.26622121877E-08 -1.33362706371E-08 -1.40457625520E-08 -1.47925347821E-08 -1.55785298950E-08 -1.64057911188E-08 -1.72764675386E-08 -1.81928195614E-08 -1.91572246620E-08 -2.01721834245E-08 -2.12403258955E-08 -2.23644182642E-08 -2.35473698857E-08 -2.47922406671E-08 -2.61022488326E-08 -2.74807790891E-08 -2.89313912115E-08 -3.04578290703E-08 -3.20640301230E-08 -3.37541353949E-08 -3.55324999725E-08 -3.74037040371E-08 -3.93725644664E-08 -4.14441470321E-08 -4.36237792256E-08 -4.59170637430E-08 -4.83298926636E-08 -5.08684623579E-08 -5.35392891620E-08 -5.63492258576E-08 -5.93054790004E-08 -6.24156271379E-08 -6.56876399655E-08 -6.91298984657E-08 -7.27512160839E-08 -7.65608609917E-08 -8.05685794952E-08 -8.47846206457E-08 -8.92197621158E-08 -9.38853374046E-08 -9.87932644417E-08 -1.03956075660E-07 -1.09386949614E-07 -1.15099744224E-07 -1.21109031724E-07 -1.27430135411E-07 -1.34079168276E-07 -1.41073073624E-07 -1.48429667776E-07 -1.56167684971E-07 -1.64306824562E-07 -1.72867800651E-07 -1.81872394260E-07 -1.91343508185E-07 -2.01305224673E-07 -2.11782866046E-07 -2.22803058453E-07 -2.34393798883E-07 -2.46584525621E-07 -2.59406192329E-07 -2.72891345912E-07 -2.87074208399E-07 -3.01990763010E-07 -3.17678844654E-07 -3.34178235058E-07 -3.51530762785E-07 -3.69780408383E-07 -3.88973414926E-07 -4.09158404225E-07 -4.30386499004E-07 -4.52711451343E-07 -4.76189777702E-07 -5.00880900880E-07 -5.26847299246E-07 -5.54154663626E-07 -5.82872062236E-07 -6.13072114068E-07 -6.44831171169E-07 -6.78229510259E-07 -7.13351534181E-07 -7.50285983665E-07 -7.89126159958E-07 -8.29970158851E-07 -8.72921116712E-07 -9.18087469112E-07 -9.65583222715E-07 -1.01552824109E-06 -1.06804854516E-06 -1.12327662906E-06 -1.18135179216E-06 -1.24242048806E-06 -1.30663669153E-06 -1.37416228419E-06 -1.44516745991E-06 -1.51983115104E-06 -1.59834147638E-06 -1.68089621213E-06 -1.76770328693E-06 -1.85898130220E-06 -1.95496007916E-06 -2.05588123376E-06 -2.16199878111E-06 -2.27357977074E-06 -2.39090495439E-06 -2.51426948794E-06 -2.64398366919E-06 -2.78037371345E-06 -2.92378256864E-06 -3.07457077211E-06 -3.23311735129E-06 -3.39982077023E-06 -3.57509992459E-06 -3.75939518738E-06 -3.95316950812E-06 -4.15690956812E-06 -4.37112699470E-06 -4.59635963741E-06 -4.83317290929E-06 -5.08216119663E-06 -5.34394934061E-06 -5.61919419442E-06 -5.90858625981E-06 -6.21285140709E-06 -6.53275268264E-06 -6.86909220861E-06 -7.22271317932E-06 -7.59450195928E-06 -7.98539028808E-06 -8.39635759731E-06 -8.82843344555E-06 -9.28270007703E-06 -9.76029511043E-06 -1.02624143643E-05 -1.07903148262E-05 -1.13453177721E-05 -1.19288120450E-05 -1.25422574992E-05 -1.31871886196E-05 -1.38652183247E-05 -1.45780419618E-05 -1.53274415056E-05 -1.61152899683E-05 -1.69435560339E-05 -1.78143089266E-05 -1.87297235254E-05 -1.96920857372E-05 -2.07037981420E-05 -2.17673859219E-05 -2.28855030908E-05 -2.40609390374E-05 -2.52966253982E-05 -2.65956432771E-05 -2.79612308282E-05 -2.93967912199E-05 -3.09059010003E-05 -3.24923188823E-05 -3.41599949693E-05 -3.59130804452E-05 -3.77559377489E-05 -3.96931512588E-05 -4.17295385128E-05 -4.38701619878E-05 -4.61203414697E-05 -4.84856670391E-05 -5.09720127052E-05 -5.35855507198E-05 -5.63327666015E-05 -5.92204749090E-05 -6.22558357963E-05 -6.54463723890E-05 -6.87999890219E-05 -7.23249903787E-05 -7.60301015770E-05 -7.99244892451E-05 -8.40177836363E-05 -8.83201018323E-05 -9.28420720858E-05 -9.75948593574E-05 -1.02590192103E-04 -1.07840390371E-04 -1.13358395270E-04 -1.19157799872E-04 -1.25252881618E-04 -1.31658636299E-04 -1.38390813676E-04 -1.45465954826E-04 -1.52901431289E-04 -1.60715486092E-04 -1.68927276748E-04 -1.77556920312E-04 -1.86625540581E-04 -1.96155317549E-04 -2.06169539204E-04 -2.16692655781E-04 -2.27750336568E-04 -2.39369529391E-04 -2.51578522878E-04 -2.64407011639E-04 -2.77886164473E-04 -2.92048695739E-04 -3.06928940016E-04 -3.22562930203E-04 -3.38988479188E-04 -3.56245265230E-04 -3.74374921227E-04 -3.93421127990E-04 -4.13429711719E-04 -4.34448745808E-04 -4.56528657178E-04 -4.79722337288E-04 -5.04085258005E-04 -5.29675592510E-04 -5.56554341426E-04 -5.84785464341E-04 -6.14436016922E-04 -6.45576293800E-04 -6.78279977418E-04 -7.12624293036E-04 -7.48690170068E-04 -7.86562409960E-04 -8.26329860772E-04 -8.68085598672E-04 -9.11927116494E-04 -9.57956519565E-04 -1.00628072894E-03 -1.05701169220E-03 -1.11026660205E-03 -1.16616812263E-03 -1.22484462400E-03 -1.28643042451E-03 -1.35106604153E-03 -1.41889845025E-03 -1.49008135083E-03 -1.56477544380E-03 -1.64314871368E-03 -1.72537672076E-03 -1.81164290098E-03 -1.90213887362E-03 -1.99706475673E-03 -2.09662948992E-03 -2.20105116419E-03 -2.31055735843E-03 -2.42538548193E-03 -2.54578312252E-03 -2.67200839943E-03 -2.80433032018E-03 -2.94302914051E-03 -3.08839672622E-03 -3.24073691583E-03 -3.40036588247E-03 -3.56761249355E-03 -3.74281866644E-03 -3.92633971800E-03 -4.11854470599E-03 -4.31981675955E-03 -4.53055339632E-03 -4.75116682279E-03 -4.98208421476E-03 -5.22374797399E-03 -5.47661595691E-03 -5.74116167087E-03 -6.01787443297E-03 -6.30725948582E-03 -6.60983806445E-03 -6.92614740758E-03 -7.25674070632E-03 -7.60218698241E-03 -7.96307088750E-03 -8.33999241444E-03 -8.73356651055E-03 -9.14442258223E-03 -9.57320387921E-03 -1.00205667461E-02 -1.04871797279E-02 -1.09737225148E-02 -1.14808847112E-02 -1.20093644128E-02 -1.25598665729E-02 -1.31331011415E-02 -1.37297809555E-02 -1.43506193598E-02 -1.49963275378E-02 -1.56676115277E-02 -1.63651689000E-02 -1.70896850719E-02 -1.78418292316E-02 -1.86222498454E-02 -1.94315697202E-02 -2.02703805928E-02 -2.11392372157E-02 -2.20386509129E-02 -2.29690825736E-02 -2.39309350573E-02 -2.49245449814E-02 -2.59501738648E-02 -2.70079986023E-02 -2.80981012473E-02 -2.92204580837E-02 -3.03749279699E-02 -3.15612399452E-02 -3.27789800914E-02 -3.40275776521E-02 -3.53062904175E-02 -3.66141893935E-02 -3.79501427822E-02 -3.93127993163E-02 -4.07005709990E-02 -4.21116153203E-02 -4.35438170345E-02 -4.49947696045E-02 -4.64617564360E-02 -4.79417320509E-02 -4.94313033682E-02 -5.09267112880E-02 -5.24238128017E-02 -5.39180638741E-02 -5.54045033756E-02 -5.68777383646E-02 -5.83319310509E-02 -5.97607877912E-02 -6.11575504922E-02 -6.25149908132E-02 -6.38254075706E-02 -6.50806277546E-02 -6.62720115627E-02 -6.73904618415E-02 -6.84264383020E-02 -6.93699768335E-02 -7.02107141849E-02 -7.09379182104E-02 -7.15405237835E-02 -7.20071743767E-02 -7.23262691770E-02 -7.24860154649E-02 -7.24744858380E-02 -7.22796796987E-02 -7.18895882826E-02 -7.12922623708E-02 -7.04758817379E-02 -6.94288253529E-02 -6.81397414081E-02 -6.65976164197E-02 -6.47918429856E-02 -6.27122863185E-02 -6.03493504637E-02 -5.76940461956E-02 -5.47380640104E-02 -5.14738574256E-02 -4.78947439693E-02 -4.39950337608E-02 -3.97701983742E-02 -3.52170955731E-02 -3.03342682390E-02 -2.51223379758E-02 -1.95845148589E-02 -1.37272437828E-02 -7.56100374596E-03 -1.10126781881E-03 5.63038322685E-03 1.26050234727E-02 1.97850832838E-02 2.71230968233E-02 3.45606597842E-02 4.20278295433E-02 4.94432741211E-02 5.67155451024E-02 6.37458905727E-02 7.04329973314E-02 7.66798898583E-02 8.24028073565E-02 8.75410563184E-02 9.20653254959E-02 9.59793420817E-02 9.93054233213E-02 1.02043377944E-01 1.04159565800E-01 1.05620033601E-01 1.06396122943E-01 1.06465350514E-01 1.05812336829E-01 1.04429773332E-01 1.02319384210E-01 9.94928923566E-02 9.59729193245E-02 9.17938009984E-02 8.70021977741E-02 8.16574251471E-02 7.58313126837E-02 6.96074641450E-02 6.30797096592E-02 5.63496941000E-02 4.95235821396E-02 4.27081423708E-02 3.60065802474E-02 2.95147138693E-02 2.33179830294E-02 1.74896778631E-02 1.20903846024E-02 7.16842389419E-03 2.76082802999E-03 -1.10550226887E-03 -4.41270135632E-03 -7.15089508198E-03 -9.31711898865E-03 -1.09140927601E-02 -1.19489144134E-02 -1.24319892473E-02 -1.23768775494E-02 -1.18022173429E-02 -1.07374793340E-02 -9.23510347338E-03 -7.39259838564E-03 -5.38671449860E-03 -3.46519615169E-03 -1.86624967755E-03 -7.58538417301E-04 -1.82376222540E-04 -1.11117546497E-05 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 -2.44338626692E+00 1.08134381693E+01 -8.99558278989E+00 -4.33223334852E+01 1.50847184844E+02 -2.14314521388E+02 1.48133772513E+02 -4.06489195720E+01 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 3.73526172013E+00 -1.08997535081E+02 8.75109913006E+02 -3.33688509302E+03 6.95720380638E+03 -8.13112125852E+03 5.00446172258E+03 -1.26412063134E+03 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 3 6 2 i j (l(j)) 0.00000000000E+00 Q_int 0.00000000000E+00 5.66983197196E-18 4.65117602793E-17 1.60979031928E-16 3.91334768401E-16 7.83919630572E-16 1.38943582704E-15 2.26324839547E-15 3.46570473729E-15 5.06247343975E-15 7.12490347554E-15 9.73040492972E-15 1.29628524662E-14 1.69130128119E-14 2.16789976062E-14 2.73667430355E-14 3.40905177525E-14 4.19734606558E-14 5.11481501963E-14 6.17572069632E-14 7.39539313980E-14 8.79029785846E-14 1.03781072169E-13 1.21777759570E-13 1.42096210769E-13 1.64954063063E-13 1.90584314335E-13 2.19236267492E-13 2.51176528886E-13 2.86690063683E-13 3.26081311285E-13 3.69675364108E-13 4.17819213164E-13 4.70883064099E-13 5.29261727526E-13 5.93376087689E-13 6.63674653739E-13 7.40635198086E-13 8.24766486567E-13 9.16610105404E-13 1.01674239018E-12 1.12577646240E-12 1.24436437936E-12 1.37319940352E-12 1.51301839787E-12 1.66460435389E-12 1.82878905944E-12 2.00645591405E-12 2.19854289947E-12 2.40604571388E-12 2.63002107854E-12 2.87159022606E-12 3.13194258013E-12 3.41233963689E-12 3.71411905863E-12 4.03869899143E-12 4.38758261841E-12 4.76236296134E-12 5.16472794378E-12 5.59646572978E-12 6.05947035263E-12 6.55574764932E-12 7.08742151679E-12 7.65674050716E-12 8.26608477995E-12 8.91797343015E-12 9.61507221222E-12 1.03602016809E-11 1.11563457707E-11 1.20066608384E-11 1.29144851907E-11 1.38833491258E-11 1.49169855133E-11 1.60193409427E-11 1.71945874697E-11 1.84471349914E-11 1.97816442853E-11 2.12030407451E-11 2.27165288512E-11 2.43276074143E-11 2.60420856328E-11 2.78661000069E-11 2.98061321544E-11 3.18690275750E-11 3.40620154151E-11 3.63927292822E-11 3.88692291672E-11 4.15000245313E-11 4.42940986184E-11 4.72609340581E-11 5.04105398261E-11 5.37534796339E-11 5.73009018224E-11 6.10645708376E-11 6.50569003722E-11 6.92909882597E-11 7.37806532123E-11 7.85404735005E-11 8.35858276735E-11 8.89329374297E-11 9.45989127475E-11 1.00601799396E-10 1.06960628947E-10 1.13695471427E-10 1.20827490731E-10 1.28379002960E-10 1.36373537828E-10 1.44835903286E-10 1.53792253559E-10 1.63270160737E-10 1.73298690143E-10 1.83908479646E-10 1.95131823134E-10 2.07002758373E-10 2.19557159463E-10 2.32832834143E-10 2.46869626190E-10 2.61709523185E-10 2.77396769911E-10 2.93977987695E-10 3.11502299980E-10 3.30021464478E-10 3.49590012211E-10 3.70265393839E-10 3.92108133613E-10 4.15181991377E-10 4.39554133025E-10 4.65295309850E-10 4.92480047258E-10 5.21186843312E-10 5.51498377641E-10 5.83501731227E-10 6.17288617651E-10 6.52955626387E-10 6.90604478762E-10 7.30342297245E-10 7.72281888759E-10 8.16542042724E-10 8.63247844619E-10 9.12531005847E-10 9.64530210753E-10 1.01939148169E-09 1.07726856303E-09 1.13832332520E-09 1.20272618963E-09 1.27065657578E-09 1.34230337146E-09 1.41786542750E-09 1.49755207808E-09 1.58158368810E-09 1.67019222900E-09 1.76362188430E-09 1.86212968671E-09 1.96598618820E-09 2.07547616478E-09 2.19089935786E-09 2.31257125406E-09 2.44082390532E-09 2.57600679158E-09 2.71848772818E-09 2.86865382010E-09 3.02691246580E-09 3.19369241284E-09 3.36944486835E-09 3.55464466674E-09 3.74979149804E-09 3.95541119963E-09 4.17205711492E-09 4.40031152221E-09 4.64078713747E-09 4.89412869485E-09 5.16101460884E-09 5.44215872242E-09 5.73831214550E-09 6.05026518844E-09 6.37884939533E-09 6.72493968251E-09 7.08945658741E-09 7.47336863359E-09 7.87769481792E-09 8.30350722621E-09 8.75193378383E-09 9.22416114839E-09 9.72143775170E-09 1.02450769987E-08 1.07964606316E-08 1.13770422675E-08 1.19883511184E-08 1.26319959035E-08 1.33096689629E-08 1.40231505840E-08 1.47743135501E-08 1.55651279248E-08 1.63976660818E-08 1.72741079953E-08 1.81967468021E-08 1.91679946508E-08 2.01903888525E-08 2.12665983488E-08 2.23994305123E-08 2.35918382983E-08 2.48469277644E-08 2.61679659784E-08 2.75583893322E-08 2.90218122849E-08 3.05620365565E-08 3.21830607939E-08 3.38890907359E-08 3.56845499008E-08 3.75740908245E-08 3.95626068777E-08 4.16552446907E-08 4.38574172181E-08 4.61748174759E-08 4.86134329862E-08 5.11795609644E-08 5.38798242884E-08 5.67211882897E-08 5.97109784081E-08 6.28568987551E-08 6.61670516319E-08 6.96499580521E-08 7.33145793192E-08 7.71703397151E-08 8.12271503543E-08 8.54954342658E-08 8.99861527646E-08 9.47108331792E-08 9.96815980049E-08 1.04911195556E-07 1.10413032195E-07 1.16201206215E-07 1.22290543469E-07 1.28696634829E-07 1.35435875566E-07 1.42525506762E-07 1.49983658842E-07 1.57829397352E-07 1.66082771080E-07 1.74764862656E-07 1.83897841753E-07 1.93505021014E-07 2.03610914861E-07 2.14241301318E-07 2.25423287015E-07 2.37185375530E-07 2.49557539237E-07 2.62571294849E-07 2.76259782841E-07 2.90657850948E-07 3.05802141954E-07 3.21731185985E-07 3.38485497547E-07 3.56107677540E-07 3.74642520514E-07 3.94137127428E-07 4.14641024197E-07 4.36206286331E-07 4.58887669958E-07 4.82742749587E-07 5.07832062931E-07 5.34219263163E-07 5.61971278991E-07 5.91158482939E-07 6.21854868267E-07 6.54138234967E-07 6.88090385304E-07 7.23797329377E-07 7.61349501239E-07 8.00841986093E-07 8.42374759142E-07 8.86052936689E-07 9.31987040115E-07 9.80293273389E-07 1.03109381482E-06 1.08451712373E-06 1.14069826292E-06 1.19977923757E-06 1.26190935162E-06 1.32724558231E-06 1.39595297399E-06 1.46820505208E-06 1.54418425826E-06 1.62408240791E-06 1.70810117109E-06 1.79645257803E-06 1.88935955059E-06 1.98705646094E-06 2.08978971885E-06 2.19781838900E-06 2.31141484000E-06 2.43086542651E-06 2.55647120643E-06 2.68854869467E-06 2.82743065557E-06 2.97346693585E-06 3.12702534019E-06 3.28849255163E-06 3.45827509900E-06 3.63680037389E-06 3.82451769962E-06 4.02189945482E-06 4.22944225458E-06 4.44766819189E-06 4.67712614252E-06 4.91839313669E-06 5.17207580075E-06 5.43881187258E-06 5.71927179434E-06 6.01416038663E-06 6.32421860811E-06 6.65022540499E-06 6.99299965492E-06 7.35340221011E-06 7.73233804468E-06 8.13075851160E-06 8.54966371475E-06 8.99010500193E-06 9.45318758503E-06 9.94007329368E-06 1.04519834693E-05 1.09902020067E-05 1.15560785504E-05 1.21510318537E-05 1.27765533093E-05 1.34342106587E-05 1.41256518915E-05 1.48526093419E-05 1.56169039941E-05 1.64204500069E-05 1.72652594674E-05 1.81534473870E-05 1.90872369508E-05 2.00689650332E-05 2.11010879939E-05 2.21861877680E-05 2.33269782643E-05 2.45263120884E-05 2.57871876065E-05 2.71127563667E-05 2.85063308963E-05 2.99713928930E-05 3.15116018312E-05 3.31308040028E-05 3.48330420150E-05 3.66225647674E-05 3.85038379333E-05 4.04815549687E-05 4.25606486772E-05 4.47463033568E-05 4.70439675588E-05 4.94593674882E-05 5.19985210781E-05 5.46677527710E-05 5.74737090428E-05 6.04233747048E-05 6.35240900233E-05 6.67835686969E-05 7.02099167328E-05 7.38116522678E-05 7.75977263787E-05 8.15775449316E-05 8.57609915210E-05 9.01584515505E-05 9.47808375128E-05 9.96396155250E-05 1.04746833183E-04 1.10115148794E-04 1.15757862061E-04 1.21688946281E-04 1.27923082139E-04 1.34475693161E-04 1.41362982920E-04 1.48601974073E-04 1.56210549310E-04 1.64207494314E-04 1.72612542822E-04 1.81446423896E-04 1.90730911484E-04 2.00488876415E-04 2.10744340903E-04 2.21522535701E-04 2.32849960026E-04 2.44754444374E-04 2.57265216356E-04 2.70412969708E-04 2.84229936609E-04 2.98749963449E-04 3.14008590224E-04 3.30043133696E-04 3.46892774507E-04 3.64598648405E-04 3.83203941774E-04 4.02753991651E-04 4.23296390425E-04 4.44881095421E-04 4.67560543576E-04 4.91389771424E-04 5.16426540609E-04 5.42731469163E-04 5.70368168780E-04 5.99403388328E-04 6.29907163863E-04 6.61952975387E-04 6.95617910622E-04 7.30982836082E-04 7.68132575695E-04 8.07156097291E-04 8.48146707219E-04 8.91202253404E-04 9.36425337135E-04 9.83923533898E-04 1.03380962354E-03 1.08620183009E-03 1.14122407158E-03 1.19900622007E-03 1.25968437229E-03 1.32340113123E-03 1.39030589883E-03 1.46055518020E-03 1.53431289964E-03 1.61175072865E-03 1.69304842635E-03 1.77839419238E-03 1.86798503264E-03 1.96202713797E-03 2.06073627610E-03 2.16433819683E-03 2.27306905066E-03 2.38717582090E-03 2.50691676929E-03 2.63256189510E-03 2.76439340755E-03 2.90270621144E-03 3.04780840568E-03 3.20002179447E-03 3.35968241053E-03 3.52714104997E-03 3.70276381806E-03 3.88693268504E-03 4.08004605107E-03 4.28251931911E-03 4.49478547440E-03 4.71729566909E-03 4.95051981004E-03 5.19494714805E-03 5.45108686591E-03 5.71946866287E-03 6.00064333256E-03 6.29518333097E-03 6.60368333081E-03 6.92676075817E-03 7.26505630682E-03 7.61923442498E-03 7.98998376896E-03 8.37801761728E-03 8.78407423834E-03 9.20891720402E-03 9.65333564069E-03 1.01181444084E-02 1.06041841980E-02 1.11123215354E-02 1.16434486800E-02 1.21984834052E-02 1.27783686452E-02 1.33840719937E-02 1.40165850362E-02 1.46769224982E-02 1.53661211892E-02 1.60852387202E-02 1.68353519726E-02 1.76175552915E-02 1.84329583790E-02 1.92826838560E-02 2.01678644633E-02 2.10896398681E-02 2.20491530411E-02 2.30475461667E-02 2.40859560469E-02 2.51655089562E-02 2.62873149049E-02 2.74524612633E-02 2.86620056986E-02 2.99169683748E-02 3.12183233621E-02 3.25669892037E-02 3.39638185829E-02 3.54095870346E-02 3.69049806455E-02 3.84505826840E-02 4.00468591045E-02 4.16941428702E-02 4.33926170414E-02 4.51422965775E-02 4.69430088091E-02 4.87943725368E-02 5.06957757248E-02 5.26463517621E-02 5.46449542795E-02 5.66901305168E-02 5.87800932552E-02 6.09126913445E-02 6.30853788745E-02 6.52951830646E-02 6.75386709706E-02 6.98119151388E-02 7.21104583682E-02 7.44292777799E-02 7.67627484346E-02 7.91046067772E-02 8.14479142423E-02 8.37850213971E-02 8.61075330575E-02 8.84062748618E-02 9.06712618469E-02 9.28916696261E-02 9.50558088191E-02 9.71511034415E-02 9.91640739996E-02 1.01080326082E-01 1.02884545258E-01 1.04560499113E-01 1.06091047247E-01 1.07458160022E-01 1.08642946814E-01 1.09625694433E-01 1.10385916241E-01 1.10902412378E-01 1.11153341286E-01 1.11116302474E-01 1.10768430223E-01 1.10086497562E-01 1.09047029532E-01 1.07626424339E-01 1.05801080660E-01 1.03547528947E-01 1.00842564313E-01 9.76633783423E-02 9.39876871104E-02 8.97938528607E-02 8.50609972622E-02 7.97691050243E-02 7.38991180426E-02 6.74330222522E-02 6.03539321238E-02 5.26461813453E-02 4.42954327787E-02 3.52888262737E-02 2.56151893248E-02 1.52653426639E-02 4.23254030750E-03 -7.48690929343E-03 -1.98927885655E-02 -3.29798270980E-02 -4.67362151374E-02 -6.11417296836E-02 -7.61654485282E-02 -9.17630624713E-02 -1.07873850402E-01 -1.24417460824E-01 -1.41290750866E-01 -1.58365071908E-01 -1.75484556923E-01 -1.92466146774E-01 -2.09102263872E-01 -2.25167148255E-01 -2.40427818217E-01 -2.54660243904E-01 -2.67670365206E-01 -2.79317628230E-01 -2.89535110380E-01 -2.98334063097E-01 -3.05770331516E-01 -3.11847262928E-01 -3.16488833034E-01 -3.19617350591E-01 -3.21166377085E-01 -3.21082537267E-01 -3.19327382127E-01 -3.15879251536E-01 -3.10735047540E-01 -3.03911896960E-01 -2.95448573382E-01 -2.85406616987E-01 -2.73870965561E-01 -2.60949984916E-01 -2.46774671504E-01 -2.31496921279E-01 -2.15286721468E-01 -1.98328357673E-01 -1.80815819658E-01 -1.62947902111E-01 -1.44923563000E-01 -1.26938211632E-01 -1.09181345888E-01 -9.18357081830E-02 -7.50777003885E-02 -5.90786052085E-02 -4.40060477363E-02 -3.00252559562E-02 -1.72997389500E-02 -5.99098225527E-03 3.74351076578E-03 1.17549194942E-02 1.79121162845E-02 2.21168511762E-02 2.43267588464E-02 2.45865314529E-02 2.30642665801E-02 2.00830778705E-02 1.61250528514E-02 1.17662202164E-02 7.57861573098E-03 4.08625300807E-03 1.66254258580E-03 4.00085007066E-04 2.43793049017E-05 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 4.32234795283E+00 -1.98153244137E+01 9.40144358800E+00 1.20289718518E+02 -3.79149328898E+02 5.27848521764E+02 -3.62065478630E+02 9.89349761597E+01 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 -8.48531685881E+00 2.01096432240E+02 -1.58507533071E+03 6.02969774054E+03 -1.25694910918E+04 1.46938428812E+04 -9.04642493446E+03 2.28582551658E+03 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 4 4 1 i j (l(j)) 4.20880001997E-01 Q_int 0.00000000000E+00 9.83014652554E-12 3.99841974145E-11 9.14870041946E-11 1.65403802282E-10 2.62841674695E-10 3.84951066969E-10 5.32927355052E-10 7.08012467983E-10 9.11496567253E-10 1.14471978479E-09 1.40907402160E-09 1.70600480910E-09 2.03701323538E-09 2.40365793854E-09 2.80755716947E-09 3.25039092644E-09 3.73390316389E-09 4.25990407813E-09 4.83027247241E-09 5.44695820427E-09 6.11198471777E-09 6.82745166370E-09 7.59553761074E-09 8.41850285064E-09 9.29869230060E-09 1.02385385064E-08 1.12405647495E-08 1.23073882618E-08 1.34417235514E-08 1.46463858441E-08 1.59242946435E-08 1.72784774141E-08 1.87120733923E-08 2.02283375287E-08 2.18306445664E-08 2.35224932608E-08 2.53075107450E-08 2.71894570447E-08 2.91722297510E-08 3.12598688524E-08 3.34565617350E-08 3.57666483535E-08 3.81946265822E-08 4.07451577487E-08 4.34230723596E-08 4.62333760223E-08 4.91812555716E-08 5.22720854065E-08 5.55114340451E-08 5.89050709053E-08 6.24589733190E-08 6.61793337866E-08 7.00725674812E-08 7.41453200110E-08 7.84044754491E-08 8.28571646369E-08 8.75107737751E-08 9.23729533080E-08 9.74516271142E-08 1.02755002011E-07 1.08291577588E-07 1.14070156373E-07 1.20099854351E-07 1.26390111844E-07 1.32950704761E-07 1.39791756234E-07 1.46923748654E-07 1.54357536124E-07 1.62104357327E-07 1.70175848846E-07 1.78584058934E-07 1.87341461759E-07 1.96460972133E-07 2.05955960753E-07 2.15840269947E-07 2.26128229983E-07 2.36834675912E-07 2.47974965004E-07 2.59564994772E-07 2.71621221617E-07 2.84160680104E-07 2.97201002908E-07 3.10760441426E-07 3.24857887113E-07 3.39512893529E-07 3.54745699149E-07 3.70577250953E-07 3.87029228816E-07 4.04124070736E-07 4.21884998921E-07 4.40336046769E-07 4.59502086768E-07 4.79408859344E-07 5.00083002702E-07 5.21552083681E-07 5.43844629666E-07 5.66990161573E-07 5.91019227989E-07 6.15963440443E-07 6.41855509911E-07 6.68729284539E-07 6.96619788673E-07 7.25563263213E-07 7.55597207336E-07 7.86760421651E-07 8.19093052823E-07 8.52636639714E-07 8.87434161101E-07 9.23530085019E-07 9.60970419785E-07 9.99802766762E-07 1.04007637491E-06 1.08184219723E-06 1.12515294908E-06 1.17006316850E-06 1.21662927862E-06 1.26490965216E-06 1.31496467813E-06 1.36685683079E-06 1.42065074101E-06 1.47641326998E-06 1.53421358554E-06 1.59412324095E-06 1.65621625651E-06 1.72056920384E-06 1.78726129310E-06 1.85637446309E-06 1.92799347454E-06 2.00220600648E-06 2.07910275591E-06 2.15877754085E-06 2.24132740698E-06 2.32685273777E-06 2.41545736844E-06 2.50724870384E-06 2.60233784021E-06 2.70083969118E-06 2.80287311806E-06 2.90856106448E-06 3.01803069569E-06 3.13141354256E-06 3.24884565047E-06 3.37046773327E-06 3.49642533249E-06 3.62686898196E-06 3.76195437796E-06 3.90184255528E-06 4.04670006914E-06 4.19669918337E-06 4.35201806496E-06 4.51284098520E-06 4.67935852772E-06 4.85176780353E-06 5.03027267337E-06 5.21508397770E-06 5.40641977441E-06 5.60450558462E-06 5.80957464690E-06 6.02186818005E-06 6.24163565481E-06 6.46913507488E-06 6.70463326741E-06 6.94840618332E-06 7.20073920798E-06 7.46192748227E-06 7.73227623461E-06 8.01210112430E-06 8.30172859651E-06 8.60149624923E-06 8.91175321284E-06 9.23286054241E-06 9.56519162346E-06 9.90913259138E-06 1.02650827652E-05 1.06334550959E-05 1.10146766302E-05 1.14091889901E-05 1.18174488683E-05 1.22399285405E-05 1.26771163960E-05 1.31295174850E-05 1.35976540852E-05 1.40820662879E-05 1.45833126029E-05 1.51019705851E-05 1.56386374822E-05 1.61939309032E-05 1.67684895113E-05 1.73629737390E-05 1.79780665281E-05 1.86144740948E-05 1.92729267204E-05 1.99541795692E-05 2.06590135338E-05 2.13882361095E-05 2.21426822981E-05 2.29232155424E-05 2.37307286923E-05 2.45661450040E-05 2.54304191726E-05 2.63245384003E-05 2.72495235005E-05 2.82064300392E-05 2.91963495155E-05 3.02204105819E-05 3.12797803060E-05 3.23756654752E-05 3.35093139452E-05 3.46820160348E-05 3.58951059676E-05 3.71499633626E-05 3.84480147758E-05 3.97907352932E-05 4.11796501788E-05 4.26163365777E-05 4.41024252777E-05 4.56396025297E-05 4.72296119303E-05 4.88742563690E-05 5.05754000397E-05 5.23349705217E-05 5.41549609311E-05 5.60374321445E-05 5.79845150987E-05 5.99984131682E-05 6.20814046227E-05 6.42358451693E-05 6.64641705787E-05 6.87688994029E-05 7.11526357828E-05 7.36180723522E-05 7.61679932398E-05 7.88052771733E-05 8.15329006875E-05 8.43539414431E-05 8.72715816555E-05 9.02891116422E-05 9.34099334879E-05 9.66375648363E-05 9.99756428080E-05 1.03427928053E-04 1.06998308938E-04 1.10690805881E-04 1.14509575821E-04 1.18458916856E-04 1.22543273023E-04 1.26767239247E-04 1.31135566456E-04 1.35653166871E-04 1.40325119469E-04 1.45156675641E-04 1.50153265033E-04 1.55320501584E-04 1.60664189780E-04 1.66190331102E-04 1.71905130709E-04 1.77815004334E-04 1.83926585424E-04 1.90246732509E-04 1.96782536838E-04 2.03541330251E-04 2.10530693339E-04 2.17758463863E-04 2.25232745468E-04 2.32961916685E-04 2.40954640244E-04 2.49219872695E-04 2.57766874358E-04 2.66605219608E-04 2.75744807506E-04 2.85195872796E-04 2.94968997260E-04 3.05075121472E-04 3.15525556937E-04 3.26331998645E-04 3.37506538049E-04 3.49061676476E-04 3.61010339001E-04 3.73365888775E-04 3.86142141849E-04 3.99353382490E-04 4.13014379015E-04 4.27140400162E-04 4.41747232009E-04 4.56851195463E-04 4.72469164344E-04 4.88618584068E-04 5.05317490969E-04 5.22584532264E-04 5.40438986700E-04 5.58900785877E-04 5.77990536311E-04 5.97729542225E-04 6.18139829106E-04 6.39244168060E-04 6.61066100983E-04 6.83629966579E-04 7.06960927242E-04 7.31084996853E-04 7.56029069506E-04 7.81820949196E-04 8.08489380497E-04 8.36064080281E-04 8.64575770492E-04 8.94056212012E-04 9.24538239672E-04 9.56055798436E-04 9.88643980772E-04 1.02233906531E-03 1.05717855675E-03 1.09320122714E-03 1.13044715851E-03 1.16895778695E-03 1.20877594809E-03 1.24994592423E-03 1.29251349287E-03 1.33652597702E-03 1.38203229704E-03 1.42908302433E-03 1.47773043668E-03 1.52802857560E-03 1.58003330538E-03 1.63380237426E-03 1.68939547757E-03 1.74687432292E-03 1.80630269759E-03 1.86774653816E-03 1.93127400238E-03 1.99695554348E-03 2.06486398685E-03 2.13507460935E-03 2.20766522109E-03 2.28271625002E-03 2.36031082922E-03 2.44053488708E-03 2.52347724044E-03 2.60922969072E-03 2.69788712326E-03 2.78954760987E-03 2.88431251467E-03 2.98228660345E-03 3.08357815653E-03 3.18829908528E-03 3.29656505244E-03 3.40849559629E-03 3.52421425883E-03 3.64384871811E-03 3.76753092476E-03 3.89539724298E-03 4.02758859594E-03 4.16425061592E-03 4.30553379913E-03 4.45159366554E-03 4.60259092376E-03 4.75869164105E-03 4.92006741885E-03 5.08689557366E-03 5.25935932373E-03 5.43764798153E-03 5.62195715221E-03 5.81248893827E-03 6.00945215057E-03 6.21306252581E-03 6.42354295071E-03 6.64112369324E-03 6.86604264052E-03 7.09854554439E-03 7.33888627417E-03 7.58732707706E-03 7.84413884647E-03 8.10960139823E-03 8.38400375509E-03 8.66764443966E-03 8.96083177584E-03 9.26388419928E-03 9.57713057658E-03 9.90091053394E-03 1.02355747952E-02 1.05814855294E-02 1.09390167081E-02 1.13085544735E-02 1.16904975151E-02 1.20852574589E-02 1.24932592658E-02 1.29149416406E-02 1.33507574537E-02 1.38011741720E-02 1.42666743022E-02 1.47477558456E-02 1.52449327639E-02 1.57587354577E-02 1.62897112562E-02 1.68384249191E-02 1.74054591512E-02 1.79914151281E-02 1.85969130351E-02 1.92225926185E-02 1.98691137484E-02 2.05371569948E-02 2.12274242151E-02 2.19406391548E-02 2.26775480596E-02 2.34389202998E-02 2.42255490066E-02 2.50382517199E-02 2.58778710474E-02 2.67452753350E-02 2.76413593477E-02 2.85670449603E-02 2.95232818588E-02 3.05110482499E-02 3.15313515795E-02 3.25852292593E-02 3.36737493992E-02 3.47980115470E-02 3.59591474323E-02 3.71583217143E-02 3.83967327324E-02 3.96756132574E-02 4.09962312434E-02 4.23598905766E-02 4.37679318206E-02 4.52217329558E-02 4.67227101105E-02 4.82723182821E-02 4.98720520440E-02 5.15234462375E-02 5.32280766445E-02 5.49875606374E-02 5.68035578033E-02 5.86777705382E-02 6.06119446076E-02 6.26078696670E-02 6.46673797413E-02 6.67923536524E-02 6.89847153954E-02 7.12464344520E-02 7.35795260377E-02 7.59860512756E-02 7.84681172876E-02 8.10278771969E-02 8.36675300323E-02 8.63893205253E-02 8.91955387900E-02 9.20885198772E-02 9.50706431875E-02 9.81443317367E-02 1.01312051258E-01 1.04576309128E-01 1.07939653104E-01 1.11404669850E-01 1.14973983257E-01 1.18650252507E-01 1.22436169896E-01 1.26334458376E-01 1.30347868810E-01 1.34479176902E-01 1.38731179804E-01 1.43106692356E-01 1.47608542944E-01 1.52239568954E-01 1.57002611788E-01 1.61900511418E-01 1.66936100457E-01 1.72112197699E-01 1.77431601118E-01 1.82897080278E-01 1.88511368133E-01 1.94277152171E-01 2.00197064881E-01 2.06273673489E-01 2.12509468952E-01 2.18906854142E-01 2.25468131208E-01 2.32195488068E-01 2.39090983986E-01 2.46156534214E-01 2.53393893638E-01 2.60804639416E-01 2.68390152551E-01 2.76151598379E-01 2.84089905932E-01 2.92205746148E-01 3.00499508903E-01 3.08971278843E-01 3.17620809987E-01 3.26447499101E-01 3.35450357822E-01 3.44627983548E-01 3.53978529073E-01 3.63499671018E-01 3.73188577049E-01 3.83041871943E-01 3.93055602541E-01 4.03225201654E-01 4.13545451001E-01 4.24010443270E-01 4.34613543434E-01 4.45347349429E-01 4.56203652382E-01 4.67173396544E-01 4.78246639156E-01 4.89412510469E-01 5.00659174179E-01 5.11973788590E-01 5.23342468800E-01 5.34750250298E-01 5.46181054339E-01 5.57617655539E-01 5.69041652148E-01 5.80433439486E-01 5.91772187071E-01 6.03035820020E-01 6.14201005266E-01 6.25243143244E-01 6.36136365665E-01 6.46853540009E-01 6.57366281429E-01 6.67644972684E-01 6.77658792792E-01 6.87375755001E-01 6.96762754694E-01 7.05785627793E-01 7.14409220155E-01 7.22597468399E-01 7.30313492524E-01 7.37519700567E-01 7.44177905464E-01 7.50249454148E-01 7.55695368812E-01 7.60476500145E-01 7.64553692239E-01 7.67887958789E-01 7.70440670145E-01 7.72173750768E-01 7.73049886687E-01 7.73032742704E-01 7.72087189324E-01 7.70179539743E-01 7.67277797758E-01 7.63351918127E-01 7.58374081787E-01 7.52318989361E-01 7.45164177684E-01 7.36890365351E-01 7.27481834877E-01 7.16926860425E-01 7.05218191344E-01 6.92353602640E-01 6.78336523545E-01 6.63176754330E-01 6.46891278619E-01 6.29505173181E-01 6.11052608520E-01 5.91577920666E-01 5.71136716124E-01 5.49796947304E-01 5.27639863455E-01 5.04760702729E-01 4.81268944287E-01 4.57287889062E-01 4.32953288514E-01 4.08410704468E-01 3.83811277797E-01 3.59305639419E-01 3.35035863621E-01 3.11125713225E-01 2.87670073047E-01 2.64725577823E-01 2.42306262736E-01 2.20390952361E-01 1.98953578520E-01 1.78025685973E-01 1.57702425269E-01 1.38085346676E-01 1.19273875398E-01 1.01363869917E-01 8.44460583022E-02 6.86043483689E-02 5.39140126936E-02 4.04397792732E-02 2.82338572323E-02 1.73339665124E-02 7.76146282761E-03 -4.80296331345E-04 -7.40715621223E-03 -1.30547063796E-02 -1.74779214052E-02 -2.07497196570E-02 -2.29584079247E-02 -2.42042115168E-02 -2.45953541865E-02 -2.42443248555E-02 -2.32649621260E-02 -2.17706966576E-02 -1.98738810468E-02 -1.76856670204E-02 -1.53157453179E-02 -1.28712847923E-02 -1.04548324035E-02 -8.16118197907E-03 -6.07360872784E-03 -4.25976242924E-03 -2.76762542874E-03 -1.62163119630E-03 -8.19251910757E-04 -3.28425374654E-04 -8.72521067043E-05 -9.10617336330E-06 -1.78606449617E-07 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 8.20338351539E+00 -3.03653769467E+01 4.61583317588E+01 -1.39180496875E+01 -7.95845219474E+01 1.54873725871E+02 -1.20973726631E+02 3.57287924572E+01 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2.02496112339E+01 4.26087198150E+01 -1.06150540945E+03 4.91734080358E+03 -1.12186649441E+04 1.39073871603E+04 -8.94588845782E+03 2.34019420857E+03 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 4 5 2 i j (l(j)) 0.00000000000E+00 Q_int 0.00000000000E+00 -5.71751483813E-18 -4.69029207323E-17 -1.62332853645E-16 -3.94625864779E-16 -7.90512336542E-16 -1.40112087937E-15 -2.28228214681E-15 -3.49485105752E-15 -5.10504846677E-15 -7.18482338691E-15 -9.81223691624E-15 -1.30718690985E-14 -1.70552500025E-14 -2.18613163791E-14 -2.75968953310E-14 -3.43772165021E-14 -4.23264543806E-14 -5.15783023931E-14 -6.22765805584E-14 -7.45758785642E-14 -8.86422362328E-14 -1.04653863444E-13 -1.22801901700E-13 -1.43291229627E-13 -1.66341314838E-13 -1.92187114716E-13 -2.21080028788E-13 -2.53288905552E-13 -2.89101106714E-13 -3.28823631992E-13 -3.72784307815E-13 -4.21333043369E-13 -4.74843157712E-13 -5.33712781793E-13 -5.98366339474E-13 -6.69256111847E-13 -7.46863889367E-13 -8.31702716571E-13 -9.24318734398E-13 -1.02529312540E-12 -1.13524416740E-12 -1.25482940148E-12 -1.38474792043E-12 -1.52574278422E-12 -1.67860356927E-12 -1.84416905877E-12 -2.02333008163E-12 -2.21703250800E-12 -2.42628040989E-12 -2.65213939555E-12 -2.89574012718E-12 -3.15828203152E-12 -3.44103721389E-12 -3.74535458635E-12 -4.07266422160E-12 -4.42448194455E-12 -4.80241417434E-12 -5.20816303002E-12 -5.64353171415E-12 -6.11043018892E-12 -6.61088116052E-12 -7.14702638795E-12 -7.72113333382E-12 -8.33560217492E-12 -8.99297319204E-12 -9.69593455884E-12 -1.04473305511E-11 -1.12501701988E-11 -1.21076364036E-11 -1.30230955479E-11 -1.40001076202E-11 -1.50424368841E-11 -1.61540631203E-11 -1.73391934721E-11 -1.86022749247E-11 -1.99480074535E-11 -2.13813578756E-11 -2.29075744421E-11 -2.45322022099E-11 -2.62610992340E-11 -2.81004536240E-11 -3.00568015096E-11 -3.21370459631E-11 -3.43484769299E-11 -3.66987922183E-11 -3.91961196064E-11 -4.18490401225E-11 -4.46666125628E-11 -4.76583993090E-11 -5.08344935162E-11 -5.42055477409E-11 -5.77828040861E-11 -6.15781259418E-11 -6.56040314057E-11 -6.98737284702E-11 -7.44011520699E-11 -7.92010030861E-11 -8.42887894102E-11 -8.96808691743E-11 -9.53944962621E-11 -1.01447868219E-10 -1.07860176685E-10 -1.14651660488E-10 -1.21843661528E-10 -1.29458683602E-10 -1.37520454324E-10 -1.46053990304E-10 -1.55085665744E-10 -1.64643284640E-10 -1.74756156783E-10 -1.85455177733E-10 -1.96772913005E-10 -2.08743686658E-10 -2.21403674531E-10 -2.34791002370E-10 -2.48945849087E-10 -2.63910555427E-10 -2.79729738332E-10 -2.96450411275E-10 -3.14122110897E-10 -3.32797030266E-10 -3.52530159094E-10 -3.73379431290E-10 -3.95405880213E-10 -4.18673802036E-10 -4.43250927636E-10 -4.69208603456E-10 -4.96621981802E-10 -5.25570221062E-10 -5.56136696370E-10 -5.88409221246E-10 -6.22480280788E-10 -6.58447277008E-10 -6.96412786956E-10 -7.36484834269E-10 -7.78777174865E-10 -8.23409597505E-10 -8.70508239987E-10 -9.20205921786E-10 -9.72642494003E-10 -1.02796520749E-09 -1.08632910012E-09 -1.14789740418E-09 -1.21284197494E-09 -1.28134374144E-09 -1.35359318074E-09 -1.42979081678E-09 -1.51014774508E-09 -1.59488618476E-09 -1.68424005911E-09 -1.77845560637E-09 -1.87779202209E-09 -1.98252213488E-09 -2.09293311716E-09 -2.20932723274E-09 -2.33202262317E-09 -2.46135413482E-09 -2.59767418880E-09 -2.74135369597E-09 -2.89278301931E-09 -3.05237298611E-09 -3.22055595261E-09 -3.39778692370E-09 -3.58454473060E-09 -3.78133326944E-09 -3.98868280399E-09 -4.20715133571E-09 -4.43732604469E-09 -4.67982480514E-09 -4.93529777916E-09 -5.20442909299E-09 -5.48793859987E-09 -5.78658373401E-09 -6.10116146037E-09 -6.43251032522E-09 -6.78151261259E-09 -7.14909661213E-09 -7.53623900415E-09 -7.94396736779E-09 -8.37336281870E-09 -8.82556278294E-09 -9.30176391406E-09 -9.80322516078E-09 -1.03312709930E-08 -1.08872947942E-08 -1.14727624291E-08 -1.20892159953E-08 -1.27382777683E-08 -1.34216543503E-08 -1.41411410326E-08 -1.48986263838E-08 -1.56960970736E-08 -1.65356429459E-08 -1.74194623534E-08 -1.83498677673E-08 -1.93292916757E-08 -2.03602927868E-08 -2.14455625513E-08 -2.25879320208E-08 -2.37903790600E-08 -2.50560359304E-08 -2.63881972646E-08 -2.77903284516E-08 -2.92660744537E-08 -3.08192690781E-08 -3.24539447255E-08 -3.41743426409E-08 -3.59849236926E-08 -3.78903797057E-08 -3.98956453797E-08 -4.20059108189E-08 -4.42266347089E-08 -4.65635581705E-08 -4.90227193271E-08 -5.16104686217E-08 -5.43334849224E-08 -5.71987924567E-08 -6.02137786170E-08 -6.33862126823E-08 -6.67242655035E-08 -7.02365302012E-08 -7.39320439281E-08 -7.78203107515E-08 -8.19113257122E-08 -8.62156001213E-08 -9.07441881576E-08 -9.55087148336E-08 -1.00521405399E-07 -1.05795116257E-07 -1.11343367468E-07 -1.17180376929E-07 -1.23321096306E-07 -1.29781248814E-07 -1.36577368943E-07 -1.43726844224E-07 -1.51247959137E-07 -1.59159941286E-07 -1.67483009938E-07 -1.76238427061E-07 -1.85448550984E-07 -1.95136892816E-07 -2.05328175759E-07 -2.16048397478E-07 -2.27324895664E-07 -2.39186416977E-07 -2.51663189521E-07 -2.64786999048E-07 -2.78591269079E-07 -2.93111145130E-07 -3.08383583277E-07 -3.24447443260E-07 -3.41343586377E-07 -3.59114978396E-07 -3.77806797765E-07 -3.97466549362E-07 -4.18144184102E-07 -4.39892224678E-07 -4.62765897757E-07 -4.86823272963E-07 -5.12125409005E-07 -5.38736507289E-07 -5.66724073436E-07 -5.96159087072E-07 -6.27116180349E-07 -6.59673825618E-07 -6.93914532737E-07 -7.29925056511E-07 -7.67796614770E-07 -8.07625117640E-07 -8.49511408583E-07 -8.93561517800E-07 -9.39886928634E-07 -9.88604857653E-07 -1.03983854909E-06 -1.09371758437E-06 -1.15037820760E-06 -1.20996366760E-06 -1.27262457766E-06 -1.33851929357E-06 -1.40781431122E-06 -1.48068468440E-06 -1.55731446420E-06 -1.63789716081E-06 -1.72263622907E-06 -1.81174557889E-06 -1.90545011185E-06 -2.00398628528E-06 -2.10760270532E-06 -2.21656075027E-06 -2.33113522601E-06 -2.45161505493E-06 -2.57830400020E-06 -2.71152142715E-06 -2.85160310361E-06 -2.99890204140E-06 -3.15378938073E-06 -3.31665532007E-06 -3.48791009361E-06 -3.66798499871E-06 -3.85733347606E-06 -4.05643224516E-06 -4.26578249783E-06 -4.48591115299E-06 -4.71737217556E-06 -4.96074796293E-06 -5.21665080236E-06 -5.48572440307E-06 -5.76864550661E-06 -6.06612557972E-06 -6.37891259377E-06 -6.70779289528E-06 -7.05359317207E-06 -7.41718252001E-06 -7.79947461547E-06 -8.20142999885E-06 -8.62405847487E-06 -9.06842163555E-06 -9.53563551222E-06 -1.00268733630E-05 -1.05433686027E-05 -1.10864178827E-05 -1.16573843275E-05 -1.22577009375E-05 -1.28888741648E-05 -1.35524876720E-05 -1.42502062827E-05 -1.49837801339E-05 -1.57550490399E-05 -1.65659470790E-05 -1.74185074148E-05 -1.83148673625E-05 -1.92572737140E-05 -2.02480883344E-05 -2.12897940441E-05 -2.23850008000E-05 -2.35364521921E-05 -2.47470322711E-05 -2.60197727230E-05 -2.73578604098E-05 -2.87646452937E-05 -3.02436487639E-05 -3.17985723881E-05 -3.34333071079E-05 -3.51519429024E-05 -3.69587789428E-05 -3.88583342624E-05 -4.08553589694E-05 -4.29548460278E-05 -4.51620436375E-05 -4.74824682413E-05 -4.99219181921E-05 -5.24864881130E-05 -5.51825839848E-05 -5.80169389976E-05 -6.09966302052E-05 -6.41290960221E-05 -6.74221546056E-05 -7.08840231672E-05 -7.45233382592E-05 -7.83491770875E-05 -8.23710798979E-05 -8.65990734937E-05 -9.10436959379E-05 -9.57160225006E-05 -1.00627692912E-04 -1.05790939991E-04 -1.11218619703E-04 -1.16924242746E-04 -1.22922007703E-04 -1.29226835872E-04 -1.35854407838E-04 -1.42821201879E-04 -1.50144534289E-04 -1.57842601724E-04 -1.65934525667E-04 -1.74440399101E-04 -1.83381335525E-04 -1.92779520399E-04 -2.02658265164E-04 -2.13042063934E-04 -2.23956653017E-04 -2.35429073380E-04 -2.47487736215E-04 -2.60162491751E-04 -2.73484701462E-04 -2.87487313847E-04 -3.02204943944E-04 -3.17673956757E-04 -3.33932554785E-04 -3.51020869853E-04 -3.68981059433E-04 -3.87857407690E-04 -4.07696431453E-04 -4.28546991362E-04 -4.50460408419E-04 -4.73490586198E-04 -4.97694138991E-04 -5.23130526139E-04 -5.49862192858E-04 -5.77954717846E-04 -6.07476967977E-04 -6.38501260421E-04 -6.71103532507E-04 -7.05363519692E-04 -7.41364941988E-04 -7.79195699242E-04 -8.18948075636E-04 -8.60718953834E-04 -9.04610039192E-04 -9.50728094460E-04 -9.99185185443E-04 -1.05009893808E-03 -1.10359280742E-03 -1.15979635903E-03 -1.21884556330E-03 -1.28088310323E-03 -1.34605869623E-03 -1.41452943044E-03 -1.48646011634E-03 -1.56202365399E-03 -1.64140141672E-03 -1.72478365184E-03 -1.81236989897E-03 -1.90436942673E-03 -2.00100168837E-03 -2.10249679717E-03 -2.20909602211E-03 -2.32105230474E-03 -2.43863079778E-03 -2.56210942627E-03 -2.69177947200E-03 -2.82794618187E-03 -2.97092940106E-03 -3.12106423154E-03 -3.27870171680E-03 -3.44420955346E-03 -3.61797283037E-03 -3.80039479602E-03 -3.99189765476E-03 -4.19292339256E-03 -4.40393463280E-03 -4.62541552267E-03 -4.85787265061E-03 -5.10183599529E-03 -5.35785990634E-03 -5.62652411719E-03 -5.90843479015E-03 -6.20422559375E-03 -6.51455881228E-03 -6.84012648739E-03 -7.18165159128E-03 -7.53988923096E-03 -7.91562788294E-03 -8.30969065725E-03 -8.72293658977E-03 -9.15626196124E-03 -9.61060164136E-03 -1.00869304558E-02 -1.05862645739E-02 -1.11096629138E-02 -1.16582285624E-02 -1.22331102057E-02 -1.28355035666E-02 -1.34666528433E-02 -1.41278521454E-02 -1.48204469198E-02 -1.55458353604E-02 -1.63054697947E-02 -1.71008580377E-02 -1.79335647053E-02 -1.88052124762E-02 -1.97174832911E-02 -2.06721194777E-02 -2.16709247875E-02 -2.27157653299E-02 -2.38085703872E-02 -2.49513330938E-02 -2.61461109604E-02 -2.73950262221E-02 -2.87002659891E-02 -3.00640821756E-02 -3.14887911806E-02 -3.29767732943E-02 -3.45304717984E-02 -3.61523917299E-02 -3.78450982740E-02 -3.96112147492E-02 -4.14534201473E-02 -4.33744461860E-02 -4.53770738314E-02 -4.74641292463E-02 -4.96384791132E-02 -5.19030252848E-02 -5.42606987081E-02 -5.67144525670E-02 -5.92672545880E-02 -6.19220784493E-02 -6.46818942340E-02 -6.75496578644E-02 -7.05282994568E-02 -7.36207105319E-02 -7.68297300166E-02 -8.01581289764E-02 -8.36085940131E-02 -8.71837092673E-02 -9.08859369686E-02 -9.47175964742E-02 -9.86808417469E-02 -1.02777637223E-01 -1.07009732029E-01 -1.11378632515E-01 -1.15885573069E-01 -1.20531485211E-01 -1.25316964940E-01 -1.30242238356E-01 -1.35307125559E-01 -1.40511002866E-01 -1.45852763388E-01 -1.51330776028E-01 -1.56942842973E-01 -1.62686155784E-01 -1.68557250187E-01 -1.74551959697E-01 -1.80665368222E-01 -1.86891761804E-01 -1.93224579681E-01 -1.99656364855E-01 -2.06178714379E-01 -2.12782229577E-01 -2.19456466424E-01 -2.26189886334E-01 -2.32969807599E-01 -2.39782357759E-01 -2.46612427181E-01 -2.53443624165E-01 -2.60258231934E-01 -2.67037167917E-01 -2.73759945824E-01 -2.80404641121E-01 -2.86947860673E-01 -2.93364717542E-01 -2.99628812204E-01 -3.05712221793E-01 -3.11585499482E-01 -3.17217686593E-01 -3.22576340777E-01 -3.27627584314E-01 -3.32336177490E-01 -3.36665622938E-01 -3.40578307758E-01 -3.44035691100E-01 -3.46998545529E-01 -3.49427260696E-01 -3.51282217378E-01 -3.52524238425E-01 -3.53115120179E-01 -3.53018242916E-01 -3.52199251283E-01 -3.50626784890E-01 -3.48273224797E-01 -3.45115403292E-01 -3.41135202740E-01 -3.36319946033E-01 -3.30662460159E-01 -3.24160683063E-01 -3.16816695272E-01 -3.08635113476E-01 -2.99620918842E-01 -2.89777063865E-01 -2.79102694520E-01 -2.67593670693E-01 -2.55248465073E-01 -2.42082792490E-01 -2.28133987206E-01 -2.13450481934E-01 -1.98090744703E-01 -1.82123663415E-01 -1.65628810338E-01 -1.48696566207E-01 -1.31428048222E-01 -1.13934808302E-01 -9.63382278640E-02 -7.87685558206E-02 -6.13635046316E-02 -4.42663507062E-02 -2.76234904200E-02 -1.15814772549E-02 3.71635405676E-03 1.81334413404E-02 3.15433676659E-02 4.38326274597E-02 5.49023815590E-02 6.46690056321E-02 7.30635068805E-02 8.00302545947E-02 8.55256247683E-02 8.95172239051E-02 9.19840802039E-02 9.29179941004E-02 9.23259277236E-02 9.02333544221E-02 8.66884552113E-02 8.17672830767E-02 7.55799451172E-02 6.82778424355E-02 6.00615219771E-02 5.11881141836E-02 4.19761961465E-02 3.28045958236E-02 2.40999559435E-02 1.63067155525E-02 9.83868635229E-03 5.00995133608E-03 1.93797554823E-03 4.45877710421E-04 2.61157402227E-05 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 -4.35869857838E+00 1.19945032838E+01 -1.25462892701E+01 -5.80739452803E+00 4.19712004518E+01 -6.42847470403E+01 4.54993884138E+01 -1.26394882410E+01 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 -2.99755712071E+00 -1.64214826105E+02 1.49819084479E+03 -5.81188418141E+03 1.21470803097E+04 -1.41931247932E+04 8.72822836746E+03 -2.20267879274E+03 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 4 6 2 i j (l(j)) 0.00000000000E+00 Q_int 0.00000000000E+00 1.08583932000E-17 8.90754759646E-17 3.08293726218E-16 7.49451978348E-16 1.50129803291E-15 2.66093256591E-15 4.33438611789E-15 6.63723104042E-15 9.69523037998E-15 1.36450257875E-14 1.86348666549E-14 2.48253828011E-14 3.23904031539E-14 4.15178230099E-14 5.24105225916E-14 6.52873397712E-14 8.03840999828E-14 9.79547065104E-14 1.18272294511E-13 1.41630452311E-13 1.68344513710E-13 1.98752925219E-13 2.33218692381E-13 2.72130909539E-13 3.15906377649E-13 3.64991314988E-13 4.19863165869E-13 4.81032512733E-13 5.49045097299E-13 6.24483956739E-13 7.07971681168E-13 8.00172799086E-13 9.01796297738E-13 1.01359828577E-12 1.13638480589E-12 1.27101480574E-12 1.41840327556E-12 1.57952456162E-12 1.75541586509E-12 1.94718093624E-12 2.15599397470E-12 2.38310374672E-12 2.62983793129E-12 2.89760770750E-12 3.18791259592E-12 3.50234556797E-12 3.84259843744E-12 4.21046754949E-12 4.60785978302E-12 5.03679888330E-12 5.49943214243E-12 5.99803744645E-12 6.53503070856E-12 7.11297370917E-12 7.73458236456E-12 8.40273544694E-12 9.12048378011E-12 9.89105993600E-12 1.07178884588E-11 1.16045966448E-11 1.25550259075E-11 1.35732437591E-11 1.46635564412E-11 1.58305222391E-11 1.70789655156E-11 1.84139915041E-11 1.98410018983E-11 2.13657112840E-11 2.29941644552E-11 2.47327546621E-11 2.65882428409E-11 2.85677778763E-11 3.06789179514E-11 3.29296530436E-11 3.53284286253E-11 3.78841706338E-11 4.06063117780E-11 4.35048192508E-11 4.65902239222E-11 4.98736510917E-11 5.33668528800E-11 5.70822423490E-11 6.10329294379E-11 6.52327588140E-11 6.96963497358E-11 7.44391380369E-11 7.94774203394E-11 8.48284006154E-11 9.05102392200E-11 9.65421045236E-11 1.02944227281E-10 1.09737957883E-10 1.16945826633E-10 1.24591607221E-10 1.32700383547E-10 1.41298620079E-10 1.50414235930E-10 1.60076682843E-10 1.70317027292E-10 1.81168036912E-10 1.92664271489E-10 2.04842178743E-10 2.17740195150E-10 2.31398852085E-10 2.45860887532E-10 2.61171363684E-10 2.77377790722E-10 2.94530257091E-10 3.12681566628E-10 3.31887382886E-10 3.52206381031E-10 3.73700407713E-10 3.96434649310E-10 4.20477809007E-10 4.45902293138E-10 4.72784407300E-10 5.01204562729E-10 5.31247493483E-10 5.63002484985E-10 5.96563614521E-10 6.32030004315E-10 6.69506087827E-10 7.09101889974E-10 7.50933321976E-10 7.95122491614E-10 8.41798029670E-10 8.91095433410E-10 9.43157427984E-10 9.98134346678E-10 1.05618453099E-09 1.11747475155E-09 1.18218065100E-09 1.25048720992E-09 1.32258923703E-09 1.39869188490E-09 1.47901119254E-09 1.56377465623E-09 1.65322182994E-09 1.74760495715E-09 1.84718963542E-09 1.95225551549E-09 2.06309703678E-09 2.18002420111E-09 2.30336338657E-09 2.43345820368E-09 2.57067039602E-09 2.71538078761E-09 2.86799027951E-09 3.02892089802E-09 3.19861689744E-09 3.37754591985E-09 3.56620021521E-09 3.76509792460E-09 3.97478443006E-09 4.19583377437E-09 4.42885015443E-09 4.67446949200E-09 4.93336108582E-09 5.20622934933E-09 5.49381563832E-09 5.79690017332E-09 6.11630406139E-09 6.45289142263E-09 6.80757162681E-09 7.18130164556E-09 7.57508852644E-09 7.98999199489E-09 8.42712719076E-09 8.88766754643E-09 9.37284781363E-09 9.88396724690E-09 1.04223929514E-08 1.09895634041E-08 1.15869921563E-08 1.22162717284E-08 1.28790777048E-08 1.35771730415E-08 1.43124125951E-08 1.50867478862E-08 1.59022321092E-08 1.67610253997E-08 1.76654003750E-08 1.86177479597E-08 1.96205835123E-08 2.06765532684E-08 2.17884411155E-08 2.29591757181E-08 2.41918380100E-08 2.54896690733E-08 2.68560784238E-08 2.82946527232E-08 2.98091649416E-08 3.14035839915E-08 3.30820848589E-08 3.48490592565E-08 3.67091268267E-08 3.86671469212E-08 4.07282309883E-08 4.28977555980E-08 4.51813761393E-08 4.75850412220E-08 5.01150078215E-08 5.27778572029E-08 5.55805116669E-08 5.85302521562E-08 6.16347367704E-08 6.49020202334E-08 6.83405743641E-08 7.19593096003E-08 7.57675976315E-08 7.97752951967E-08 8.39927691070E-08 8.84309225569E-08 9.31012227895E-08 9.80157301853E-08 1.03187128849E-07 1.08628758770E-07 1.14354649635E-07 1.20379556388E-07 1.26718996611E-07 1.33389289831E-07 1.40407598854E-07 1.47791973218E-07 1.55561394885E-07 1.63735826283E-07 1.72336260818E-07 1.81384775985E-07 1.90904589205E-07 2.00920116545E-07 2.11457034445E-07 2.22542344623E-07 2.34204442321E-07 2.46473188054E-07 2.59379983051E-07 2.72957848570E-07 2.87241509297E-07 3.02267481024E-07 3.18074162837E-07 3.34701934041E-07 3.52193256068E-07 3.70592779618E-07 3.89947457312E-07 4.10306662122E-07 4.31722311900E-07 4.54249000292E-07 4.77944134388E-07 5.02868079437E-07 5.29084310998E-07 5.56659574904E-07 5.85664055449E-07 6.16171552206E-07 6.48259665927E-07 6.82009993997E-07 7.17508335919E-07 7.54844909349E-07 7.94114577231E-07 8.35417086589E-07 8.78857319583E-07 9.24545557451E-07 9.72597758006E-07 1.02313584737E-06 1.07628802669E-06 1.13218909461E-06 1.19098078627E-06 1.25281212970E-06 1.31783982056E-06 1.38622861604E-06 1.45815174903E-06 1.53379136349E-06 1.61333897224E-06 1.69699593812E-06 1.78497397997E-06 1.87749570446E-06 1.97479516528E-06 2.07711845096E-06 2.18472430287E-06 2.29788476492E-06 2.41688586657E-06 2.54202834089E-06 2.67362837942E-06 2.81201842575E-06 2.95754800979E-06 3.11058462484E-06 3.27151464958E-06 3.44074431740E-06 3.61870073532E-06 3.80583295525E-06 4.00261310010E-06 4.20953754759E-06 4.42712817482E-06 4.65593366650E-06 4.89653089030E-06 5.14952634268E-06 5.41555766871E-06 5.69529525989E-06 5.98944393368E-06 6.29874469916E-06 6.62397661308E-06 6.96595873099E-06 7.32555215829E-06 7.70366220629E-06 8.10124065863E-06 8.51928815385E-06 8.95885668979E-06 9.42105225626E-06 9.90703760247E-06 1.04180351460E-05 1.09553300307E-05 1.15202733411E-05 1.21142854810E-05 1.27388597254E-05 1.33955659535E-05 1.40860545729E-05 1.48120606448E-05 1.55754082192E-05 1.63780148930E-05 1.72218965997E-05 1.81091726452E-05 1.90420709996E-05 2.00229338607E-05 2.10542235009E-05 2.21385284126E-05 2.32785697682E-05 2.44772082091E-05 2.57374509822E-05 2.70624594393E-05 2.84555569210E-05 2.99202370410E-05 3.14601723946E-05 3.30792237101E-05 3.47814494679E-05 3.65711160087E-05 3.84527081587E-05 4.04309403939E-05 4.25107685757E-05 4.46974022820E-05 4.69963177676E-05 4.94132715839E-05 5.19543148915E-05 5.46258085013E-05 5.74344386808E-05 6.03872337634E-05 6.34915816029E-05 6.67552479142E-05 7.01863955459E-05 7.37936047322E-05 7.75858943719E-05 8.15727443875E-05 8.57641192192E-05 9.01704925091E-05 9.48028730371E-05 9.96728319711E-05 1.04792531497E-04 1.10174754896E-04 1.15832938149E-04 1.21781203133E-04 1.28034392500E-04 1.34608106313E-04 1.41518740543E-04 1.48783527490E-04 1.56420578265E-04 1.64448927395E-04 1.72888579685E-04 1.81760559437E-04 1.91086962145E-04 2.00891008791E-04 2.11197102863E-04 2.22030890245E-04 2.33419322106E-04 2.45390720940E-04 2.57974849923E-04 2.71202985727E-04 2.85107994992E-04 2.99724414602E-04 3.15088535982E-04 3.31238493593E-04 3.48214357830E-04 3.66058232555E-04 3.84814357472E-04 4.04529215581E-04 4.25251645975E-04 4.47032962214E-04 4.69927076559E-04 4.93990630352E-04 5.19283130817E-04 5.45867094622E-04 5.73808198487E-04 6.03175437206E-04 6.34041289420E-04 6.66481891504E-04 7.00577219969E-04 7.36411282762E-04 7.74072319887E-04 8.13653013792E-04 8.55250709964E-04 8.98967648217E-04 9.44911205158E-04 9.93194148351E-04 1.04393490273E-03 1.09725782976E-03 1.15329352007E-03 1.21217909992E-03 1.27405855242E-03 1.33908305395E-03 1.40741132649E-03 1.47921000664E-03 1.55465403204E-03 1.63392704590E-03 1.71722182043E-03 1.80474070007E-03 1.89669606525E-03 1.99331081771E-03 2.09481888803E-03 2.20146576658E-03 2.31350905868E-03 2.43121906502E-03 2.55487938832E-03 2.68478756736E-03 2.82125573937E-03 2.96461133194E-03 3.11519778561E-03 3.27337530818E-03 3.43952166211E-03 3.61403298610E-03 3.79732465207E-03 3.98983215887E-03 4.19201206402E-03 4.40434295456E-03 4.62732645862E-03 4.86148829876E-03 5.10737938849E-03 5.36557697330E-03 5.63668581749E-03 5.92133943802E-03 6.22020138675E-03 6.53396658227E-03 6.86336269248E-03 7.20915156914E-03 7.57213073552E-03 7.95313492801E-03 8.35303769290E-03 8.77275303894E-03 9.21323714659E-03 9.67549013445E-03 1.01605578835E-02 1.06695339190E-02 1.12035613511E-02 1.17638348727E-02 1.23516028152E-02 1.29681692616E-02 1.36148962145E-02 1.42932058202E-02 1.50045826444E-02 1.57505760000E-02 1.65328023221E-02 1.73529475891E-02 1.82127697849E-02 1.91141013982E-02 2.00588519544E-02 2.10490105738E-02 2.20866485497E-02 2.31739219391E-02 2.43130741574E-02 2.55064385674E-02 2.67564410528E-02 2.80656025627E-02 2.94365416157E-02 3.08719767478E-02 3.23747288874E-02 3.39477236409E-02 3.55939934678E-02 3.73166797238E-02 3.91190345492E-02 4.10044225740E-02 4.29763224148E-02 4.50383279294E-02 4.71941491971E-02 4.94476131880E-02 5.18026640818E-02 5.42633631931E-02 5.68338884582E-02 5.95185334329E-02 6.23217057492E-02 6.52479249734E-02 6.83018198061E-02 7.14881245570E-02 7.48116748288E-02 7.82774023342E-02 8.18903287706E-02 8.56555586691E-02 8.95782711332E-02 9.36637103757E-02 9.79171749591E-02 1.02344005641E-01 1.06949571722E-01 1.11739255788E-01 1.16718436740E-01 1.21892470995E-01 1.27266671745E-01 1.32846286155E-01 1.38636470388E-01 1.44642262326E-01 1.50868551881E-01 1.57320048774E-01 1.64001247673E-01 1.70916390570E-01 1.78069426312E-01 1.85463967173E-01 1.93103242395E-01 2.00990048615E-01 2.09126697121E-01 2.17514957897E-01 2.26156000418E-01 2.35050331213E-01 2.44197728187E-01 2.53597171778E-01 2.63246772990E-01 2.73143698446E-01 2.83284092571E-01 2.93662997090E-01 3.04274268078E-01 3.15110490782E-01 3.26162892548E-01 3.37421254179E-01 3.48873820112E-01 3.60507207851E-01 3.72306317130E-01 3.84254239332E-01 3.96332167722E-01 4.08519309120E-01 4.20792797653E-01 4.33127611307E-01 4.45496492025E-01 4.57869870167E-01 4.70215794204E-01 4.82499866618E-01 4.94685187070E-01 5.06732304029E-01 5.18599176250E-01 5.30241145686E-01 5.41610923753E-01 5.52658593192E-01 5.63331628301E-01 5.73574936845E-01 5.83330927689E-01 5.92539609037E-01 6.01138723108E-01 6.09063924150E-01 6.16249007826E-01 6.22626201082E-01 6.28126522578E-01 6.32680224331E-01 6.36217325268E-01 6.38668246356E-01 6.39964554633E-01 6.40039818973E-01 6.38830573320E-01 6.36277372488E-01 6.32325910768E-01 6.26928153952E-01 6.20043410781E-01 6.11639241207E-01 6.01692068660E-01 5.90187337368E-01 5.77119043991E-01 5.62488493617E-01 5.46302213635E-01 5.28569153935E-01 5.09297684695E-01 4.88493591972E-01 4.66161445948E-01 4.42313645995E-01 4.16991695267E-01 3.90272207212E-01 3.62251514658E-01 3.33044132845E-01 3.02783239516E-01 2.71620899401E-01 2.39727991239E-01 2.07293751919E-01 1.74524887812E-01 1.41644159151E-01 1.08888383764E-01 7.65057844457E-02 4.47526675432E-02 1.38894522828E-02 -1.58238184019E-02 -4.41322526534E-02 -7.07908088427E-02 -9.55684785683E-02 -1.18251539824E-01 -1.38645612178E-01 -1.56576563323E-01 -1.71890625656E-01 -1.84454370339E-01 -1.94155182507E-01 -2.00902750684E-01 -2.04631738625E-01 -2.05305641390E-01 -2.02921744560E-01 -1.97517331589E-01 -1.89177489540E-01 -1.78045076422E-01 -1.64333311516E-01 -1.48341045139E-01 -1.30469861382E-01 -1.11240735336E-01 -9.13059769563E-02 -7.14497671793E-02 -5.25682805204E-02 -3.56188185297E-02 -2.15178650493E-02 -1.09695551263E-02 -4.24759881068E-03 -9.78137305619E-04 -5.72982048018E-05 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 8.27780326669E+00 -2.38308444678E+01 2.89192126691E+01 -4.96150976434E+00 -4.63246412762E+01 8.06654346920E+01 -5.91815358047E+01 1.67132135056E+01 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 4.96115128911E+00 3.12794567050E+02 -2.83775035537E+03 1.09991080168E+04 -2.29832569772E+04 2.68514812793E+04 -1.65112688201E+04 4.16653763551E+03 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 5 5 2 i j (l(j)) 2.44769759149E-01 Q_int 0.00000000000E+00 -4.62035230953E-14 -1.87933189339E-13 -4.30005992010E-13 -7.77428736074E-13 -1.23540491789E-12 -1.80934184559E-12 -2.50485800843E-12 -3.32779070367E-12 -4.28420392986E-12 -5.38039655565E-12 -6.62291077368E-12 -8.01854084924E-12 -9.57434217391E-12 -1.12976406347E-11 -1.31960423092E-11 -1.52774434989E-11 -1.75500411104E-11 -2.00223433988E-11 -2.27031810841E-11 -2.56017188536E-11 -2.87274672643E-11 -3.20902950579E-11 -3.57004419039E-11 -3.95685315841E-11 -4.37055856344E-11 -4.81230374602E-11 -5.28327469394E-11 -5.78470155327E-11 -6.31786019158E-11 -6.88407381539E-11 -7.48471464345E-11 -8.12120563796E-11 -8.79502229568E-11 -9.50769450085E-11 -1.02608084422E-10 -1.10560085961E-10 -1.18949997784E-10 -1.27795492667E-10 -1.37114889961E-10 -1.46927178311E-10 -1.57252039148E-10 -1.68109871000E-10 -1.79521814640E-10 -1.91509779093E-10 -2.04096468552E-10 -2.17305410205E-10 -2.31160983036E-10 -2.45688447603E-10 -2.60913976851E-10 -2.76864687981E-10 -2.93568675411E-10 -3.11055044881E-10 -3.29353948720E-10 -3.48496622328E-10 -3.68515421913E-10 -3.89443863528E-10 -4.11316663435E-10 -4.34169779873E-10 -4.58040456247E-10 -4.82967265804E-10 -5.08990157837E-10 -5.36150505487E-10 -5.64491155167E-10 -5.94056477694E-10 -6.24892421168E-10 -6.57046565667E-10 -6.90568179813E-10 -7.25508279277E-10 -7.61919687292E-10 -7.99857097234E-10 -8.39377137348E-10 -8.80538437690E-10 -9.23401699363E-10 -9.68029766119E-10 -1.01448769841E-09 -1.06284284999E-09 -1.11316494711E-09 -1.16552617042E-09 -1.22000123972E-09 -1.27666750158E-09 -1.33560501992E-09 -1.39689666972E-09 -1.46062823396E-09 -1.52688850384E-09 -1.59576938241E-09 -1.66736599175E-09 -1.74177678389E-09 -1.81910365534E-09 -1.89945206574E-09 -1.98293116040E-09 -2.06965389713E-09 -2.15973717731E-09 -2.25330198151E-09 -2.35047350970E-09 -2.45138132625E-09 -2.55615950989E-09 -2.66494680874E-09 -2.77788680072E-09 -2.89512805933E-09 -3.01682432514E-09 -3.14313468312E-09 -3.27422374602E-09 -3.41026184398E-09 -3.55142522064E-09 -3.69789623587E-09 -3.84986357549E-09 -4.00752246811E-09 -4.17107490930E-09 -4.34072989346E-09 -4.51670365360E-09 -4.69921990925E-09 -4.88851012279E-09 -5.08481376460E-09 -5.28837858715E-09 -5.49946090845E-09 -5.71832590520E-09 -5.94524791581E-09 -6.18051075387E-09 -6.42440803218E-09 -6.67724349787E-09 -6.93933137888E-09 -7.21099674229E-09 -7.49257586476E-09 -7.78441661566E-09 -8.08687885319E-09 -8.40033483392E-09 -8.72516963641E-09 -9.06178159904E-09 -9.41058277293E-09 -9.77199939009E-09 -1.01464723476E-08 -1.05344577082E-08 -1.09364272178E-08 -1.13528688410E-08 -1.17842873142E-08 -1.22312047178E-08 -1.26941610682E-08 -1.31737149290E-08 -1.36704440442E-08 -1.41849459917E-08 -1.47178388599E-08 -1.52697619467E-08 -1.58413764826E-08 -1.64333663783E-08 -1.70464389973E-08 -1.76813259556E-08 -1.83387839474E-08 -1.90195956000E-08 -1.97245703567E-08 -2.04545453903E-08 -2.12103865476E-08 -2.19929893257E-08 -2.28032798812E-08 -2.36422160747E-08 -2.45107885492E-08 -2.54100218462E-08 -2.63409755597E-08 -2.73047455285E-08 -2.83024650696E-08 -2.93353062534E-08 -3.04044812217E-08 -3.15112435511E-08 -3.26568896617E-08 -3.38427602745E-08 -3.50702419177E-08 -3.63407684836E-08 -3.76558228396E-08 -3.90169384922E-08 -4.04257013085E-08 -4.18837512956E-08 -4.33927844403E-08 -4.49545546110E-08 -4.65708755242E-08 -4.82436227776E-08 -4.99747359518E-08 -5.17662207831E-08 -5.36201514105E-08 -5.55386726976E-08 -5.75240026342E-08 -5.95784348186E-08 -6.17043410233E-08 -6.39041738492E-08 -6.61804694671E-08 -6.85358504543E-08 -7.09730287255E-08 -7.34948085632E-08 -7.61040897507E-08 -7.88038708107E-08 -8.15972523534E-08 -8.44874405379E-08 -8.74777506497E-08 -9.05716108000E-08 -9.37725657491E-08 -9.70842808590E-08 -1.00510546180E-07 -1.04055280673E-07 -1.07722536578E-07 -1.11516503926E-07 -1.15441515204E-07 -1.19502050181E-07 -1.23702740888E-07 -1.28048376777E-07 -1.32543910043E-07 -1.37194461132E-07 -1.42005324431E-07 -1.46981974153E-07 -1.52130070415E-07 -1.57455465525E-07 -1.62964210473E-07 -1.68662561652E-07 -1.74556987795E-07 -1.80654177144E-07 -1.86961044869E-07 -1.93484740727E-07 -2.00232656981E-07 -2.07212436583E-07 -2.14431981636E-07 -2.21899462131E-07 -2.29623324987E-07 -2.37612303379E-07 -2.45875426395E-07 -2.54422029001E-07 -2.63261762348E-07 -2.72404604418E-07 -2.81860871028E-07 -2.91641227200E-07 -3.01756698909E-07 -3.12218685224E-07 -3.23038970849E-07 -3.34229739090E-07 -3.45803585240E-07 -3.57773530420E-07 -3.70153035871E-07 -3.82956017728E-07 -3.96196862275E-07 -4.09890441710E-07 -4.24052130430E-07 -4.38697821857E-07 -4.53843945810E-07 -4.69507486465E-07 -4.85706000891E-07 -5.02457638209E-07 -5.19781159370E-07 -5.37695957591E-07 -5.56222079459E-07 -5.75380246721E-07 -5.95191878796E-07 -6.15679116013E-07 -6.36864843619E-07 -6.58772716557E-07 -6.81427185056E-07 -7.04853521057E-07 -7.29077845489E-07 -7.54127156430E-07 -7.80029358184E-07 -8.06813291288E-07 -8.34508763492E-07 -8.63146581737E-07 -8.92758585149E-07 -9.23377679103E-07 -9.55037870370E-07 -9.87774303378E-07 -1.02162329764E-06 -1.05662238637E-06 -1.09281035630E-06 -1.13022728877E-06 -1.16891460214E-06 -1.20891509548E-06 -1.25027299367E-06 -1.29303399387E-06 -1.33724531351E-06 -1.38295573967E-06 -1.43021568005E-06 -1.47907721553E-06 -1.52959415425E-06 -1.58182208748E-06 -1.63581844703E-06 -1.69164256458E-06 -1.74935573260E-06 -1.80902126733E-06 -1.87070457342E-06 -1.93447321064E-06 -2.00039696251E-06 -2.06854790698E-06 -2.13900048912E-06 -2.21183159598E-06 -2.28712063359E-06 -2.36494960617E-06 -2.44540319761E-06 -2.52856885522E-06 -2.61453687586E-06 -2.70340049447E-06 -2.79525597503E-06 -2.89020270397E-06 -2.98834328618E-06 -3.08978364354E-06 -3.19463311607E-06 -3.30300456573E-06 -3.41501448290E-06 -3.53078309559E-06 -3.65043448137E-06 -3.77409668211E-06 -3.90190182150E-06 -4.03398622539E-06 -4.17049054496E-06 -4.31155988272E-06 -4.45734392142E-06 -4.60799705572E-06 -4.76367852679E-06 -4.92455255964E-06 -5.09078850332E-06 -5.26256097384E-06 -5.44004999990E-06 -5.62344117111E-06 -5.81292578906E-06 -6.00870102067E-06 -6.21097005415E-06 -6.41994225721E-06 -6.63583333745E-06 -6.85886550489E-06 -7.08926763627E-06 -7.32727544118E-06 -7.57313162961E-06 -7.82708608080E-06 -8.08939601310E-06 -8.36032615454E-06 -8.64014891377E-06 -8.92914455108E-06 -9.22760134905E-06 -9.53581578241E-06 -9.85409268658E-06 -1.01827454245E-05 -1.05220960510E-05 -1.08724754744E-05 -1.12342236138E-05 -1.16076895528E-05 -1.19932316872E-05 -1.23912178670E-05 -1.28020255309E-05 -1.32260418330E-05 -1.36636637596E-05 -1.41152982359E-05 -1.45813622204E-05 -1.50622827860E-05 -1.55584971860E-05 -1.60704529034E-05 -1.65986076811E-05 -1.71434295322E-05 -1.77053967270E-05 -1.82849977545E-05 -1.88827312567E-05 -1.94991059320E-05 -2.01346404053E-05 -2.07898630609E-05 -2.14653118361E-05 -2.21615339705E-05 -2.28790857066E-05 -2.36185319402E-05 -2.43804458116E-05 -2.51654082368E-05 -2.59740073707E-05 -2.68068379974E-05 -2.76645008414E-05 -2.85476017928E-05 -2.94567510399E-05 -3.03925621006E-05 -3.13556507448E-05 -3.23466337998E-05 -3.33661278269E-05 -3.44147476618E-05 -3.54931048055E-05 -3.66018056552E-05 -3.77414495623E-05 -3.89126267041E-05 -4.01159157539E-05 -4.13518813355E-05 -4.26210712439E-05 -4.39240134152E-05 -4.52612126269E-05 -4.66331469068E-05 -4.80402636301E-05 -4.94829752806E-05 -5.09616548510E-05 -5.24766308544E-05 -5.40281819209E-05 -5.56165309450E-05 -5.72418387543E-05 -5.89041972618E-05 -6.06036220653E-05 -6.23400444539E-05 -6.41133027774E-05 -6.59231331340E-05 -6.77691593264E-05 -6.96508820333E-05 -7.15676671423E-05 -7.35187331806E-05 -7.55031377838E-05 -7.75197631305E-05 -7.95673002732E-05 -8.16442322841E-05 -8.37488161356E-05 -8.58790632254E-05 -8.80327184510E-05 -9.02072377335E-05 -9.23997638827E-05 -9.46071006881E-05 -9.68256851134E-05 -9.90515574642E-05 -1.01280329389E-04 -1.03507149565E-04 -1.05726666911E-04 -1.07932991160E-04 -1.10119650607E-04 -1.12279546849E-04 -1.14404906305E-04 -1.16487228305E-04 -1.18517229516E-04 -1.20484784462E-04 -1.22378861866E-04 -1.24187456556E-04 -1.25897516624E-04 -1.27494865522E-04 -1.28964118783E-04 -1.30288594989E-04 -1.31450220621E-04 -1.32429428393E-04 -1.33205048642E-04 -1.33754193325E-04 -1.34052132152E-04 -1.34072160332E-04 -1.33785457422E-04 -1.33160936690E-04 -1.32165084391E-04 -1.30761788334E-04 -1.28912155051E-04 -1.26574314860E-04 -1.23703214065E-04 -1.20250393500E-04 -1.16163752571E-04 -1.11387297907E-04 -1.05860875676E-04 -9.95198865955E-05 -9.22949825611E-05 -8.41117438256E-05 -7.48903355507E-05 -6.45451425219E-05 -5.29843807445E-05 -4.01096845748E-05 -2.58156679765E-05 -9.98945842003E-06 7.48979812579E-06 2.67514627335E-05 4.79339612877E-05 7.11853762596E-05 9.66640743386E-05 1.24539371848E-04 1.54992239958E-04 1.88216051772E-04 2.24417373473E-04 2.63816801754E-04 3.06649849865E-04 3.53167884671E-04 4.03639117199E-04 4.58349649199E-04 5.17604578333E-04 5.81729164655E-04 6.51070061091E-04 7.25996610694E-04 8.06902213442E-04 8.94205765438E-04 9.88353173295E-04 1.08981894657E-03 1.19910787104E-03 1.31675676552E-03 1.44333632505E-03 1.57945305292E-03 1.72575128406E-03 1.88291530216E-03 2.05167155260E-03 2.23279095317E-03 2.42709130408E-03 2.63543979870E-03 2.85875563581E-03 3.09801273395E-03 3.35424254764E-03 3.62853698496E-03 3.92205142502E-03 4.23600783329E-03 4.57169797170E-03 4.93048669954E-03 5.31381536011E-03 5.72320524658E-03 6.16026113944E-03 6.62667490625E-03 7.12422915245E-03 7.65480091049E-03 8.22036535203E-03 8.82299950596E-03 9.46488596214E-03 1.01483165381E-02 1.08756958830E-02 1.16495449892E-02 1.24725045790E-02 1.33473383290E-02 1.42769358919E-02 1.52643156679E-02 1.63126272764E-02 1.74251536699E-02 1.86053128285E-02 1.98566589651E-02 2.11828831653E-02 2.25878133799E-02 2.40754136769E-02 2.56497826549E-02 2.73151509085E-02 2.90758774286E-02 3.09364448088E-02 3.29014531214E-02 3.49756123126E-02 3.71637329579E-02 3.94707152063E-02 4.19015357305E-02 4.44612324885E-02 4.71548870914E-02 4.99876045603E-02 5.29644902458E-02 5.60906236742E-02 5.93710290757E-02 6.28106423484E-02 6.64142742022E-02 7.01865692368E-02 7.41319607036E-02 7.82546207215E-02 8.25584057275E-02 8.70467969744E-02 9.17228359218E-02 9.65890544166E-02 1.01647399621E-01 1.06899153727E-01 1.12344848592E-01 1.17984175546E-01 1.23815890775E-01 1.29837716824E-01 1.36046240998E-01 1.42436811598E-01 1.49003433229E-01 1.55738662640E-01 1.62633506834E-01 1.69677325483E-01 1.76857739921E-01 1.84160551231E-01 1.91569670095E-01 1.99067061137E-01 2.06632704390E-01 2.14244576202E-01 2.21878651308E-01 2.29508926847E-01 2.37107467713E-01 2.44644470747E-01 2.52088342911E-01 2.59405785654E-01 2.66561874520E-01 2.73520119883E-01 2.80242492249E-01 2.86689395141E-01 2.92819571966E-01 2.98589943835E-01 3.03955397712E-01 3.08868586061E-01 3.13279871247E-01 3.17137666607E-01 3.20389614975E-01 3.22985057758E-01 3.24876217922E-01 3.26017238221E-01 3.26364694261E-01 3.25878352744E-01 3.24522001030E-01 3.22264364213E-01 3.19080086882E-01 3.14950802076E-01 3.09866249441E-01 3.03825450135E-01 2.96837863196E-01 2.88924485491E-01 2.80118747561E-01 2.70467092250E-01 2.60029012739E-01 2.48876411914E-01 2.37092115711E-01 2.24767591471E-01 2.12000013253E-01 1.98889100578E-01 1.85534175022E-01 1.72031952719E-01 1.58475313829E-01 1.44953123886E-01 1.31550841573E-01 1.18351621435E-01 1.05437547637E-01 9.28908387012E-02 8.07948953928E-02 6.92351952195E-02 5.82999217974E-02 4.80801621512E-02 3.86692771643E-02 3.01609223856E-02 2.26450182479E-02 1.62009693564E-02 1.08875826588E-02 6.72964896551E-03 3.70214958199E-03 1.71471758876E-03 6.01512266724E-04 1.25040089314E-04 6.58755875274E-06 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 -3.85574333770E-02 2.81340889484E+00 -6.04482389836E+00 8.05855677144E+00 -1.03602047019E+01 1.11074029151E+01 -7.12848441673E+00 1.91812673503E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2.50908299802E+00 -5.07701833684E+00 6.96321561215E+00 -1.35932084914E+01 2.58968371169E+01 -3.09455310826E+01 1.96984350016E+01 -5.13163861247E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 -8.15424435738E+00 2.63250684593E+02 -1.92490954215E+03 6.82007356969E+03 -1.34427828076E+04 1.50290952392E+04 -8.92351946583E+03 2.18829553743E+03 5 6 2 i j (l(j)) -3.87713654334E-01 Q_int 0.00000000000E+00 7.13466405855E-14 2.90203015158E-13 6.64007437135E-13 1.20049132366E-12 1.90768981910E-12 2.79395279019E-12 3.86795620569E-12 5.13871391362E-12 6.61558982992E-12 8.30831055261E-12 1.02269784161E-11 1.23820850006E-11 1.47845251127E-11 1.74456112532E-11 2.03770885877E-11 2.35911504399E-11 2.71004543228E-11 3.09181385275E-11 3.50578392894E-11 3.95337085499E-11 4.43604323356E-11 4.95532497754E-11 5.51279727776E-11 6.11010063893E-11 6.74893698622E-11 7.43107184483E-11 8.15833659507E-11 8.93263080557E-11 9.75592464725E-11 1.06302613909E-10 1.15577599909E-10 1.25406177589E-10 1.35811131291E-10 1.46816085200E-10 1.58445532943E-10 1.70724868212E-10 1.83680416449E-10 1.97339467619E-10 2.11730310116E-10 2.26882265838E-10 2.42825726474E-10 2.59592191040E-10 2.77214304707E-10 2.95725898968E-10 3.15162033194E-10 3.35559037613E-10 3.56954557770E-10 3.79387600523E-10 4.02898581617E-10 4.27529374894E-10 4.53323363197E-10 4.80325491024E-10 5.08582318996E-10 5.38142080186E-10 5.69054738394E-10 6.01372048421E-10 6.35147618409E-10 6.70436974327E-10 7.07297626667E-10 7.45789139428E-10 7.85973201473E-10 8.27913700326E-10 8.71676798506E-10 9.17331012477E-10 9.64947294302E-10 1.01459911610E-09 1.06636255740E-09 1.12031639547E-09 1.17654219876E-09 1.23512442357E-09 1.29615051394E-09 1.35971100507E-09 1.42589963019E-09 1.49481343117E-09 1.56655287282E-09 1.64122196122E-09 1.71892836594E-09 1.79978354663E-09 1.88390288377E-09 1.97140581399E-09 2.06241597000E-09 2.15706132525E-09 2.25547434361E-09 2.35779213415E-09 2.46415661113E-09 2.57471465955E-09 2.68961830635E-09 2.80902489735E-09 2.93309728041E-09 3.06200399464E-09 3.19591946624E-09 3.33502421097E-09 3.47950504345E-09 3.62955529375E-09 3.78537503123E-09 3.94717129611E-09 4.11515833893E-09 4.28955786812E-09 4.47059930606E-09 4.65852005387E-09 4.85356576523E-09 5.05599062953E-09 5.26605766463E-09 5.48403901971E-09 5.71021628831E-09 5.94488083212E-09 6.18833411581E-09 6.44088805321E-09 6.70286536531E-09 6.97459995050E-09 7.25643726734E-09 7.54873473043E-09 7.85186211974E-09 8.16620200386E-09 8.49215017770E-09 8.83011611505E-09 9.18052343656E-09 9.54381039369E-09 9.92043036903E-09 1.03108523938E-08 1.07155616827E-08 1.11350601874E-08 1.15698671683E-08 1.20205197862E-08 1.24875737139E-08 1.29716037686E-08 1.34732045657E-08 1.39929911954E-08 1.45315999212E-08 1.50896889034E-08 1.56679389464E-08 1.62670542716E-08 1.68877633165E-08 1.75308195612E-08 1.81970023828E-08 1.88871179390E-08 1.96020000811E-08 2.03425112992E-08 2.11095436981E-08 2.19040200078E-08 2.27268946270E-08 2.35791547029E-08 2.44618212472E-08 2.53759502906E-08 2.63226340756E-08 2.73030022906E-08 2.83182233454E-08 2.93695056903E-08 3.04580991797E-08 3.15852964823E-08 3.27524345386E-08 3.39608960689E-08 3.52121111309E-08 3.65075587316E-08 3.78487684931E-08 3.92373223753E-08 4.06748564562E-08 4.21630627739E-08 4.37036912299E-08 4.52985515572E-08 4.69495153557E-08 4.86585181958E-08 5.04275617936E-08 5.22587162600E-08 5.41541224257E-08 5.61159942451E-08 5.81466212816E-08 6.02483712772E-08 6.24236928086E-08 6.46751180341E-08 6.70052655326E-08 6.94168432395E-08 7.19126514811E-08 7.44955861125E-08 7.71686417610E-08 7.99349151799E-08 8.27976087151E-08 8.57600338890E-08 8.88256151061E-08 9.19978934836E-08 9.52805308108E-08 9.86773136435E-08 1.02192157536E-07 1.05829111416E-07 1.09592362107E-07 1.13486239006E-07 1.17515218913E-07 1.21683931032E-07 1.25997162134E-07 1.30459861895E-07 1.35077148418E-07 1.39854313937E-07 1.44796830718E-07 1.49910357150E-07 1.55200744053E-07 1.60674041191E-07 1.66336504003E-07 1.72194600567E-07 1.78255018794E-07 1.84524673866E-07 1.91010715918E-07 1.97720537993E-07 2.04661784244E-07 2.11842358434E-07 2.19270432699E-07 2.26954456624E-07 2.34903166612E-07 2.43125595576E-07 2.51631082943E-07 2.60429285011E-07 2.69530185639E-07 2.78944107298E-07 2.88681722500E-07 2.98754065597E-07 3.09172544984E-07 3.19948955709E-07 3.31095492498E-07 3.42624763221E-07 3.54549802806E-07 3.66884087617E-07 3.79641550310E-07 3.92836595186E-07 4.06484114052E-07 4.20599502616E-07 4.35198677419E-07 4.50298093333E-07 4.65914761646E-07 4.82066268735E-07 4.98770795368E-07 5.16047136638E-07 5.33914722566E-07 5.52393639374E-07 5.71504651467E-07 5.91269224144E-07 6.11709547046E-07 6.32848558391E-07 6.54709969991E-07 6.77318293106E-07 7.00698865137E-07 7.24877877195E-07 7.49882402576E-07 7.75740426168E-07 8.02480874814E-07 8.30133648669E-07 8.58729653577E-07 8.88300834502E-07 9.18880210043E-07 9.50501908071E-07 9.83201202515E-07 1.01701455134E-06 1.05197963576E-06 1.08813540069E-06 1.12552209650E-06 1.16418132217E-06 1.20415606970E-06 1.24549077010E-06 1.28823134068E-06 1.33242523398E-06 1.37812148818E-06 1.42537077910E-06 1.47422547388E-06 1.52473968635E-06 1.57696933408E-06 1.63097219727E-06 1.68680797947E-06 1.74453837017E-06 1.80422710934E-06 1.86594005394E-06 1.92974524655E-06 1.99571298599E-06 2.06391590021E-06 2.13442902131E-06 2.20732986285E-06 2.28269849958E-06 2.36061764940E-06 2.44117275789E-06 2.52445208532E-06 2.61054679621E-06 2.69955105154E-06 2.79156210362E-06 2.88668039375E-06 2.98500965271E-06 3.08665700402E-06 3.19173307028E-06 3.30035208240E-06 3.41263199193E-06 3.52869458648E-06 3.64866560833E-06 3.77267487630E-06 3.90085641083E-06 4.03334856242E-06 4.17029414353E-06 4.31184056380E-06 4.45813996884E-06 4.60934938248E-06 4.76563085265E-06 4.92715160075E-06 5.09408417475E-06 5.26660660587E-06 5.44490256893E-06 5.62916154639E-06 5.81957899607E-06 6.01635652248E-06 6.21970205191E-06 6.42983001107E-06 6.64696150931E-06 6.87132452448E-06 7.10315409222E-06 7.34269249861E-06 7.59018947628E-06 7.84590240355E-06 8.11009650684E-06 8.38304506585E-06 8.66502962165E-06 8.95634018721E-06 9.25727546039E-06 9.56814303894E-06 9.88925963738E-06 1.02209513054E-05 1.05635536472E-05 1.09174120420E-05 1.12828818645E-05 1.16603287053E-05 1.20501285909E-05 1.24526682016E-05 1.28683450890E-05 1.32975678890E-05 1.37407565331E-05 1.41983424545E-05 1.46707687890E-05 1.51584905706E-05 1.56619749187E-05 1.61817012178E-05 1.67181612866E-05 1.72718595367E-05 1.78433131178E-05 1.84330520490E-05 1.90416193340E-05 1.96695710573E-05 2.03174764608E-05 2.09859179976E-05 2.16754913608E-05 2.23868054838E-05 2.31204825106E-05 2.38771577318E-05 2.46574794835E-05 2.54621090048E-05 2.62917202511E-05 2.71469996574E-05 2.80286458480E-05 2.89373692879E-05 2.98738918693E-05 3.08389464289E-05 3.18332761887E-05 3.28576341143E-05 3.39127821832E-05 3.49994905557E-05 3.61185366395E-05 3.72707040402E-05 3.84567813870E-05 3.96775610238E-05 4.09338375550E-05 4.22264062336E-05 4.35560611794E-05 4.49235934130E-05 4.63297886918E-05 4.77754251316E-05 4.92612705976E-05 5.07880798460E-05 5.23565913977E-05 5.39675241221E-05 5.56215735111E-05 5.73194076162E-05 5.90616626265E-05 6.08489380578E-05 6.26817915244E-05 6.45607330635E-05 6.64862189759E-05 6.84586451497E-05 7.04783398271E-05 7.25455557739E-05 7.46604618064E-05 7.68231336311E-05 7.90335439434E-05 8.12915517348E-05 8.35968907485E-05 8.59491570232E-05 8.83477954582E-05 9.07920853305E-05 9.32811246876E-05 9.58138135365E-05 9.83888357420E-05 1.01004639543E-04 1.03659416590E-04 1.06351079396E-04 1.09077237089E-04 1.11835169357E-04 1.14621798438E-04 1.17433659038E-04 1.20266866020E-04 1.23117079718E-04 1.25979468702E-04 1.28848669818E-04 1.31718745329E-04 1.34583136934E-04 1.37434616473E-04 1.40265233067E-04 1.43066256478E-04 1.45828116402E-04 1.48540337437E-04 1.51191469426E-04 1.53769012864E-04 1.56259339029E-04 1.58647604491E-04 1.60917659618E-04 1.63051950670E-04 1.65031415064E-04 1.66835369348E-04 1.68441389399E-04 1.69825182339E-04 1.70960449607E-04 1.71818740621E-04 1.72369296402E-04 1.72578882507E-04 1.72411610576E-04 1.71828747751E-04 1.70788513185E-04 1.69245860799E-04 1.67152247427E-04 1.64455385378E-04 1.61098978463E-04 1.57022440399E-04 1.52160594509E-04 1.46443353515E-04 1.39795378197E-04 1.32135713589E-04 1.23377401328E-04 1.13427066668E-04 1.02184478636E-04 8.95420816485E-05 7.53844969035E-05 5.95879916858E-05 4.20199146898E-05 2.25380953269E-05 9.90204891615E-07 -2.27869226504E-05 -4.89680126020E-05 -7.77401166686E-05 -1.09303427874E-04 -1.43872145965E-04 -1.81675396151E-04 -2.22958204128E-04 -2.67982530503E-04 -3.17028367843E-04 -3.70394903711E-04 -4.28401753205E-04 -4.91390264632E-04 -5.59724902094E-04 -6.33794708904E-04 -7.14014855866E-04 -8.00828278593E-04 -8.94707408157E-04 -9.96155999483E-04 -1.10571106199E-03 -1.22394489708E-03 -1.35146724726E-03 -1.48892756145E-03 -1.63701738154E-03 -1.79647285484E-03 -1.96807737735E-03 -2.15266437257E-03 -2.35112021076E-03 -2.56438727305E-03 -2.79346716512E-03 -3.03942408460E-03 -3.30338834628E-03 -3.58656006892E-03 -3.89021302686E-03 -4.21569866945E-03 -4.56445031049E-03 -4.93798748943E-03 -5.33792050518E-03 -5.76595512248E-03 -6.22389744992E-03 -6.71365898727E-03 -7.23726183875E-03 -7.79684408698E-03 -8.39466532105E-03 -9.03311230994E-03 -9.71470481035E-03 -1.04421014959E-02 -1.12181059915E-02 -1.20456729942E-02 -1.29279144582E-02 -1.38681058176E-02 -1.48696922189E-02 -1.59362947254E-02 -1.70717164586E-02 -1.82799486289E-02 -1.95651764066E-02 -2.09317845772E-02 -2.23843629165E-02 -2.39277112165E-02 -2.55668438815E-02 -2.73069940098E-02 -2.91536168620E-02 -3.11123926125E-02 -3.31892282653E-02 -3.53902586091E-02 -3.77218460698E-02 -4.01905793105E-02 -4.28032704136E-02 -4.55669504676E-02 -4.84888633639E-02 -5.15764576000E-02 -5.48373758642E-02 -5.82794421657E-02 -6.19106462571E-02 -6.57391250821E-02 -6.97731409620E-02 -7.40210562264E-02 -7.84913039720E-02 -8.31923546263E-02 -8.81326779765E-02 -9.33207003180E-02 -9.87647563654E-02 -1.04473035568E-01 -1.10453522465E-01 -1.16713930733E-01 -1.23261630553E-01 -1.30103569000E-01 -1.37246183101E-01 -1.44695305306E-01 -1.52456061129E-01 -1.60532758758E-01 -1.68928770511E-01 -1.77646406108E-01 -1.86686777793E-01 -1.96049657482E-01 -2.05733326240E-01 -2.15734416545E-01 -2.26047747985E-01 -2.36666157247E-01 -2.47580323475E-01 -2.58778590367E-01 -2.70246786640E-01 -2.81968046845E-01 -2.93922634811E-01 -3.06087772395E-01 -3.18437476557E-01 -3.30942408128E-01 -3.43569736008E-01 -3.56283020800E-01 -3.69042122118E-01 -3.81803133924E-01 -3.94518352223E-01 -4.07136279206E-01 -4.19601667475E-01 -4.31855607205E-01 -4.43835658024E-01 -4.55476025907E-01 -4.66707783690E-01 -4.77459131814E-01 -4.87655694078E-01 -4.97220841892E-01 -5.06076040587E-01 -5.14141214266E-01 -5.21335133443E-01 -5.27575845756E-01 -5.32781199369E-01 -5.36869558610E-01 -5.39760893067E-01 -5.41378448912E-01 -5.41650362655E-01 -5.40510435414E-01 -5.37899507561E-01 -5.33766910236E-01 -5.28071995567E-01 -5.20785746704E-01 -5.11892413080E-01 -5.01391172284E-01 -4.89297733800E-01 -4.75645854680E-01 -4.60488629397E-01 -4.43899466780E-01 -4.25972546131E-01 -4.06822613257E-01 -3.86583893151E-01 -3.65408051122E-01 -3.43461166544E-01 -3.20919964217E-01 -2.97967652306E-01 -2.74789943383E-01 -2.51571737652E-01 -2.28494856238E-01 -2.05736832787E-01 -1.83470551819E-01 -1.61864276353E-01 -1.41081668920E-01 -1.21281478150E-01 -1.02616755045E-01 -8.52334914486E-02 -6.92685573031E-02 -5.48466577892E-02 -4.20758911695E-02 -3.10413894614E-02 -2.17965910362E-02 -1.43520304104E-02 -8.66224811747E-03 -4.61265234381E-03 -2.00992012022E-03 -5.81636989641E-04 7.29290306995E-06 1.14009567706E-04 5.05251874761E-05 4.31878984269E-06 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 5.95396878160E-02 -5.19976478686E+00 1.11630036153E+01 -1.24436284633E+01 1.06988115375E+01 -7.98155537213E+00 4.20195801308E+00 -1.02468464398E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 -4.79924010459E+00 1.05586635549E+01 -1.60826561309E+01 3.30078589572E+01 -6.29445956676E+01 7.50672865768E+01 -4.77745363633E+01 1.24503184554E+01 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1.62737595728E+01 -5.04187449337E+02 3.67750211828E+03 -1.30247780132E+04 2.56699120909E+04 -2.86973690546E+04 1.70382429438E+04 -4.17807872543E+03 6 6 2 i j (l(j)) 5.58402210255E-01 Q_int 0.00000000000E+00 -2.65728938703E-14 -1.08085452242E-13 -2.47308057616E-13 -4.47120257982E-13 -7.10514723476E-13 -1.04060134144E-12 -1.44061145467E-12 -1.91390224776E-12 -2.46396128670E-12 -3.09441121685E-12 -3.80901462491E-12 -4.61167907042E-12 -5.50646229265E-12 -6.49757759885E-12 -7.58939944022E-12 -8.78646918184E-12 -1.00935010735E-11 -1.15153884279E-11 -1.30572100141E-11 -1.47242366724E-11 -1.65219381596E-11 -1.84559902316E-11 -2.05322819715E-11 -2.27569233727E-11 -2.51362531840E-11 -2.76768470272E-11 -3.03855257956E-11 -3.32693643438E-11 -3.63357004779E-11 -3.95921442567E-11 -4.30465876155E-11 -4.67072143218E-11 -5.05825102756E-11 -5.46812741658E-11 -5.90126284943E-11 -6.35860309810E-11 -6.84112863632E-11 -7.34985586009E-11 -7.88583835045E-11 -8.45016817976E-11 -9.04397726295E-11 -9.66843875549E-11 -1.03247684994E-10 -1.10142265192E-10 -1.17381185693E-10 -1.24977977345E-10 -1.32946660863E-10 -1.41301763948E-10 -1.50058339014E-10 -1.59231981507E-10 -1.68838848863E-10 -1.78895680117E-10 -1.89419816186E-10 -2.00429220847E-10 -2.11942502433E-10 -2.23978936285E-10 -2.36558487960E-10 -2.49701837249E-10 -2.63430403009E-10 -2.77766368855E-10 -2.92732709728E-10 -3.08353219375E-10 -3.24652538776E-10 -3.41656185539E-10 -3.59390584303E-10 -3.77883098192E-10 -3.97162061333E-10 -4.17256812497E-10 -4.38197729893E-10 -4.60016267144E-10 -4.82744990504E-10 -5.06417617347E-10 -5.31069055968E-10 -5.56735446752E-10 -5.83454204747E-10 -6.11264063695E-10 -6.40205121570E-10 -6.70318887669E-10 -7.01648331315E-10 -7.34237932227E-10 -7.68133732605E-10 -8.03383391002E-10 -8.40036238029E-10 -8.78143333969E-10 -9.17757528354E-10 -9.58933521577E-10 -1.00172792861E-09 -1.04619934489E-09 -1.09240841446E-09 -1.14041790044E-09 -1.19029275788E-09 -1.24210020915E-09 -1.29590982179E-09 -1.35179358917E-09 -1.40982601379E-09 -1.47008419341E-09 -1.53264791022E-09 -1.59759972294E-09 -1.66502506211E-09 -1.73501232862E-09 -1.80765299559E-09 -1.88304171373E-09 -1.96127642029E-09 -2.04245845167E-09 -2.12669265996E-09 -2.21408753334E-09 -2.30475532068E-09 -2.39881216028E-09 -2.49637821305E-09 -2.59757780023E-09 -2.70253954576E-09 -2.81139652349E-09 -2.92428640943E-09 -3.04135163912E-09 -3.16273957044E-09 -3.28860265184E-09 -3.41909859638E-09 -3.55439056163E-09 -3.69464733568E-09 -3.84004352952E-09 -3.99075977588E-09 -4.14698293489E-09 -4.30890630666E-09 -4.47672985112E-09 -4.65066041529E-09 -4.83091196828E-09 -5.01770584425E-09 -5.21127099361E-09 -5.41184424278E-09 -5.61967056266E-09 -5.83500334630E-09 -6.05810469591E-09 -6.28924571967E-09 -6.52870683847E-09 -6.77677810322E-09 -7.03375952270E-09 -7.29996140267E-09 -7.57570469639E-09 -7.86132136699E-09 -8.15715476214E-09 -8.46356000136E-09 -8.78090437644E-09 -9.10956776540E-09 -9.44994306042E-09 -9.80243661028E-09 -1.01674686777E-08 -1.05454739121E-08 -1.09369018383E-08 -1.13422173621E-08 -1.17619012922E-08 -1.21964508803E-08 -1.26463803792E-08 -1.31122216197E-08 -1.35945246072E-08 -1.40938581380E-08 -1.46108104365E-08 -1.51459898141E-08 -1.57000253499E-08 -1.62735675944E-08 -1.68672892974E-08 -1.74818861592E-08 -1.81180776084E-08 -1.87766076047E-08 -1.94582454696E-08 -2.01637867438E-08 -2.08940540749E-08 -2.16498981334E-08 -2.24321985600E-08 -2.32418649453E-08 -2.40798378409E-08 -2.49470898054E-08 -2.58446264851E-08 -2.67734877307E-08 -2.77347487511E-08 -2.87295213064E-08 -2.97589549400E-08 -3.08242382523E-08 -3.19266002160E-08 -3.30673115364E-08 -3.42476860561E-08 -3.54690822063E-08 -3.67329045072E-08 -3.80406051169E-08 -3.93936854329E-08 -4.07936977461E-08 -4.22422469493E-08 -4.37409923026E-08 -4.52916492570E-08 -4.68959913384E-08 -4.85558520934E-08 -5.02731270992E-08 -5.20497760401E-08 -5.38878248514E-08 -5.57893679347E-08 -5.77565704452E-08 -5.97916706537E-08 -6.18969823867E-08 -6.40748975451E-08 -6.63278887062E-08 -6.86585118095E-08 -7.10694089300E-08 -7.35633111421E-08 -7.61430414757E-08 -7.88115179684E-08 -8.15717568159E-08 -8.44268756238E-08 -8.73800967654E-08 -9.04347508451E-08 -9.35942802749E-08 -9.68622429642E-08 -1.00242316127E-07 -1.03738300212E-07 -1.07354122956E-07 -1.11093843565E-07 -1.14961657029E-07 -1.18961898574E-07 -1.23099048251E-07 -1.27377735669E-07 -1.31802744879E-07 -1.36379019405E-07 -1.41111667439E-07 -1.46005967186E-07 -1.51067372383E-07 -1.56301517985E-07 -1.61714226019E-07 -1.67311511626E-07 -1.73099589280E-07 -1.79084879195E-07 -1.85274013925E-07 -1.91673845165E-07 -1.98291450748E-07 -2.05134141854E-07 -2.12209470430E-07 -2.19525236825E-07 -2.27089497647E-07 -2.34910573851E-07 -2.42997059055E-07 -2.51357828094E-07 -2.60002045815E-07 -2.68939176117E-07 -2.78178991250E-07 -2.87731581359E-07 -2.97607364298E-07 -3.07817095700E-07 -3.18371879329E-07 -3.29283177691E-07 -3.40562822933E-07 -3.52223028020E-07 -3.64276398193E-07 -3.76735942723E-07 -3.89615086947E-07 -4.02927684600E-07 -4.16688030445E-07 -4.30910873195E-07 -4.45611428733E-07 -4.60805393632E-07 -4.76508958972E-07 -4.92738824447E-07 -5.09512212776E-07 -5.26846884402E-07 -5.44761152472E-07 -5.63273898114E-07 -5.82404585976E-07 -6.02173280048E-07 -6.22600659739E-07 -6.43708036204E-07 -6.65517368914E-07 -6.88051282454E-07 -7.11333083523E-07 -7.35386778137E-07 -7.60237088999E-07 -7.85909473020E-07 -8.12430138966E-07 -8.39826065205E-07 -8.68125017512E-07 -8.97355566917E-07 -9.27547107535E-07 -9.58729874350E-07 -9.90934960908E-07 -1.02419433685E-06 -1.05854086525E-06 -1.09400831969E-06 -1.13063140098E-06 -1.16844575349E-06 -1.20748798099E-06 -1.24779566190E-06 -1.28940736385E-06 -1.33236265753E-06 -1.37670212953E-06 -1.42246739427E-06 -1.46970110470E-06 -1.51844696177E-06 -1.56874972236E-06 -1.62065520560E-06 -1.67421029747E-06 -1.72946295319E-06 -1.78646219759E-06 -1.84525812279E-06 -1.90590188333E-06 -1.96844568818E-06 -2.03294278952E-06 -2.09944746783E-06 -2.16801501306E-06 -2.23870170142E-06 -2.31156476751E-06 -2.38666237112E-06 -2.46405355851E-06 -2.54379821751E-06 -2.62595702592E-06 -2.71059139259E-06 -2.79776339069E-06 -2.88753568237E-06 -2.97997143405E-06 -3.07513422175E-06 -3.17308792541E-06 -3.27389661143E-06 -3.37762440241E-06 -3.48433533306E-06 -3.59409319124E-06 -3.70696134269E-06 -3.82300253854E-06 -3.94227870386E-06 -4.06485070596E-06 -4.19077810086E-06 -4.32011885609E-06 -4.45292904814E-06 -4.58926253247E-06 -4.72917058409E-06 -4.87270150633E-06 -5.01990020550E-06 -5.17080772877E-06 -5.32546076249E-06 -5.48389108801E-06 -5.64612499175E-06 -5.81218262619E-06 -5.98207731795E-06 -6.15581481926E-06 -6.33339249838E-06 -6.51479846458E-06 -6.70001062293E-06 -6.88899565351E-06 -7.08170790973E-06 -7.27808822967E-06 -7.47806265423E-06 -7.68154104514E-06 -7.88841559576E-06 -8.09855922662E-06 -8.31182385771E-06 -8.52803854822E-06 -8.74700749455E-06 -8.96850787615E-06 -9.19228753828E-06 -9.41806250020E-06 -9.64551427603E-06 -9.87428699506E-06 -1.01039843072E-05 -1.03341660582E-05 -1.05643447184E-05 -1.07939815472E-05 -1.10224824751E-05 -1.12491936824E-05 -1.14733968546E-05 -1.16943040898E-05 -1.19110524349E-05 -1.21226980244E-05 -1.23282097931E-05 -1.25264627335E-05 -1.27162306656E-05 -1.28961784851E-05 -1.30648538537E-05 -1.32206782916E-05 -1.33619376318E-05 -1.34867717909E-05 -1.35931638090E-05 -1.36789281073E-05 -1.37416979107E-05 -1.37789117747E-05 -1.37877991578E-05 -1.37653649705E-05 -1.37083730315E-05 -1.36133283553E-05 -1.34764581908E-05 -1.32936917237E-05 -1.30606383528E-05 -1.27725644394E-05 -1.24243684265E-05 -1.20105542168E-05 -1.15252026867E-05 -1.09619412128E-05 -1.03139110713E-05 -9.57373256784E-06 -8.73346774018E-06 -7.78458047029E-06 -6.71789382832E-06 -5.52354446038E-06 -4.19093381909E-06 -2.70867602306E-06 -1.06454211613E-06 7.54599516758E-07 2.76284683730E-06 4.97533222217E-06 7.40829520731E-06 1.00791602231E-05 1.30066196563E-05 1.62107225953E-05 1.97129696419E-05 2.35364141935E-05 2.77057706293E-05 3.22475298615E-05 3.71900827414E-05 4.25638518435E-05 4.84014321832E-05 5.47377414612E-05 6.16101804633E-05 6.90588042874E-05 7.71265051104E-05 8.58592072546E-05 9.53060753585E-05 1.05519736513E-04 1.16556517273E-04 1.28476696515E-04 1.41344775166E-04 1.55229763909E-04 1.70205490015E-04 1.86350924540E-04 2.03750531197E-04 2.22494638297E-04 2.42679835217E-04 2.64409394981E-04 2.87793724594E-04 3.12950844887E-04 3.40006901745E-04 3.69096710671E-04 4.00364336785E-04 4.33963712461E-04 4.70059294927E-04 5.08826766310E-04 5.50453778719E-04 5.95140747128E-04 6.43101692959E-04 6.94565141433E-04 7.49775075918E-04 8.08991952685E-04 8.72493779647E-04 9.40577262864E-04 1.01355902477E-03 1.09177689828E-03 1.17559130121E-03 1.26538669547E-03 1.36157313599E-03 1.46458791426E-03 1.57489730189E-03 1.69299839948E-03 1.81942109681E-03 1.95473014998E-03 2.09952738195E-03 2.25445401286E-03 2.42019312670E-03 2.59747228138E-03 2.78706626920E-03 2.98980003519E-03 3.20655176073E-03 3.43825612027E-03 3.68590771908E-03 3.95056471995E-03 4.23335266713E-03 4.53546851569E-03 4.85818487458E-03 5.20285447174E-03 5.57091484939E-03 5.96389329766E-03 6.38341203451E-03 6.83119363947E-03 7.30906674860E-03 7.81897201730E-03 8.36296835741E-03 8.94323945377E-03 9.56210056517E-03 1.02220056129E-02 1.09255545595E-02 1.16755010784E-02 1.24747605133E-02 1.33264181258E-02 1.42337376241E-02 1.52001699675E-02 1.62293624349E-02 1.73251679435E-02 1.84916546019E-02 1.97331154737E-02 2.10540785278E-02 2.24593167426E-02 2.39538583276E-02 2.55429970197E-02 2.72323024027E-02 2.90276301930E-02 3.09351324248E-02 3.29612674590E-02 3.51128097307E-02 3.73968591377E-02 3.98208499623E-02 4.23925592057E-02 4.51201141984E-02 4.80119993392E-02 5.10770617954E-02 5.43245159838E-02 5.77639466325E-02 6.14053102055E-02 6.52589344521E-02 6.93355158252E-02 7.36461144890E-02 7.82021466168E-02 8.30153736585E-02 8.80978882350E-02 9.34620962953E-02 9.91206951507E-02 1.05086646982E-01 1.11373147393E-01 1.17993588575E-01 1.24961516613E-01 1.32290582485E-01 1.39994486249E-01 1.48086913967E-01 1.56581466851E-01 1.65491582178E-01 1.74830445485E-01 1.84610893616E-01 1.94845308170E-01 2.05545498967E-01 2.16722577179E-01 2.28386817803E-01 2.40547511222E-01 2.53212803661E-01 2.66389526385E-01 2.80083013600E-01 2.94296909016E-01 3.09032961185E-01 3.24290807694E-01 3.40067748437E-01 3.56358508149E-01 3.73154988462E-01 3.90446009706E-01 4.08217042680E-01 4.26449930538E-01 4.45122600874E-01 4.64208768000E-01 4.83677625299E-01 5.03493527459E-01 5.23615662400E-01 5.43997712748E-01 5.64587507053E-01 5.85326661455E-01 6.06150213559E-01 6.26986251840E-01 6.47755546338E-01 6.68371189850E-01 6.88738263669E-01 7.08753548293E-01 7.28305307878E-01 7.47273187445E-01 7.65528274121E-01 7.82933387306E-01 7.99343676572E-01 8.14607617922E-01 8.28568504706E-01 8.41066522160E-01 8.51941463394E-01 8.61036072622E-01 8.68199862753E-01 8.73293010327E-01 8.76189523996E-01 8.76778229555E-01 8.74959093838E-01 8.70632569822E-01 8.63699922690E-01 8.54076196254E-01 8.41694463948E-01 8.26508565085E-01 8.08495889734E-01 7.87660171896E-01 7.64034177717E-01 7.37682246518E-01 7.08702524977E-01 6.77228806754E-01 6.43431758232E-01 6.07519390081E-01 5.69736514686E-01 5.30363054325E-01 4.89711023472E-01 4.48120244624E-01 4.05952941678E-01 3.63587665419E-01 3.21413067999E-01 2.79822155994E-01 2.39207404123E-01 1.99956870383E-01 1.62451026339E-01 1.27059819353E-01 9.41393573521E-02 6.40277260416E-02 3.70395238449E-02 1.34587435994E-02 -6.47051126994E-03 -2.25561883289E-02 -3.46742139576E-02 -4.27890184645E-02 -4.69789986479E-02 -4.74660773881E-02 -4.46463816128E-02 -3.91157324106E-02 -3.16790932905E-02 -2.33278315873E-02 -1.51641916874E-02 -8.25253831346E-03 -3.38934681966E-03 -8.23429489181E-04 -5.06613490275E-05 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 -2.21754211974E-02 8.93790653314E+00 -1.76327134682E+01 8.28029282109E+00 1.90537413161E+01 -3.93917690249E+01 3.03779363597E+01 -8.81099366449E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 9.10777865384E+00 -2.08614563716E+01 2.81814851792E+01 -4.48014382760E+01 7.67522759105E+01 -9.02299060512E+01 5.79555761297E+01 -1.53149936069E+01 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 -3.26644609732E+01 9.67281850840E+02 -7.03463648755E+03 2.49038192909E+04 -4.90761297452E+04 5.48611159532E+04 -3.25709568881E+04 7.98671119991E+03 3S 0 2.00 Wavefunction 0.00000000000E+00 2.38249210842E-07 4.80502516634E-07 7.26827211527E-07 9.77291720636E-07 1.23196561905E-06 1.49091965117E-06 1.75422575032E-06 2.02195705881E-06 2.29418794816E-06 2.57099403982E-06 2.85245222616E-06 3.13864069183E-06 3.42963893547E-06 3.72552779181E-06 4.02638945412E-06 4.33230749701E-06 4.64336689972E-06 4.95965406963E-06 5.28125686634E-06 5.60826462605E-06 5.94076818637E-06 6.27885991155E-06 6.62263371814E-06 6.97218510111E-06 7.32761116034E-06 7.68901062758E-06 8.05648389393E-06 8.43013303769E-06 8.81006185271E-06 9.19637587725E-06 9.58918242328E-06 9.98859060628E-06 1.03947113756E-05 1.08076575452E-05 1.12275438250E-05 1.16544868528E-05 1.20886052268E-05 1.25300195382E-05 1.29788524050E-05 1.34352285060E-05 1.38992746152E-05 1.43711196374E-05 1.48508946437E-05 1.53387329083E-05 1.58347699448E-05 1.63391435446E-05 1.68519938149E-05 1.73734632174E-05 1.79036966082E-05 1.84428412779E-05 1.89910469924E-05 1.95484660348E-05 2.01152532473E-05 2.06915660747E-05 2.12775646076E-05 2.18734116274E-05 2.24792726510E-05 2.30953159774E-05 2.37217127337E-05 2.43586369233E-05 2.50062654737E-05 2.56647782864E-05 2.63343582857E-05 2.70151914709E-05 2.77074669668E-05 2.84113770768E-05 2.91271173363E-05 2.98548865670E-05 3.05948869320E-05 3.13473239919E-05 3.21124067623E-05 3.28903477713E-05 3.36813631192E-05 3.44856725378E-05 3.53034994521E-05 3.61350710418E-05 3.69806183048E-05 3.78403761215E-05 3.87145833193E-05 3.96034827398E-05 4.05073213057E-05 4.14263500899E-05 4.23608243845E-05 4.33110037725E-05 4.42771521993E-05 4.52595380466E-05 4.62584342063E-05 4.72741181570E-05 4.83068720403E-05 4.93569827401E-05 5.04247419613E-05 5.15104463118E-05 5.26143973840E-05 5.37369018394E-05 5.48782714931E-05 5.60388234009E-05 5.72188799472E-05 5.84187689343E-05 5.96388236741E-05 6.08793830800E-05 6.21407917615E-05 6.34234001197E-05 6.47275644450E-05 6.60536470153E-05 6.74020161977E-05 6.87730465500E-05 7.01671189249E-05 7.15846205762E-05 7.30259452659E-05 7.44914933741E-05 7.59816720096E-05 7.74968951234E-05 7.90375836238E-05 8.06041654929E-05 8.21970759059E-05 8.38167573518E-05 8.54636597565E-05 8.71382406073E-05 8.88409650807E-05 9.05723061712E-05 9.23327448227E-05 9.41227700621E-05 9.59428791356E-05 9.77935776462E-05 9.96753796945E-05 1.01588808022E-04 1.03534394154E-04 1.05512678552E-04 1.07524210758E-04 1.09569549552E-04 1.11649263105E-04 1.13763929137E-04 1.15914135076E-04 1.18100478227E-04 1.20323565930E-04 1.22584015734E-04 1.24882455567E-04 1.27219523911E-04 1.29595869978E-04 1.32012153893E-04 1.34469046873E-04 1.36967231421E-04 1.39507401505E-04 1.42090262761E-04 1.44716532683E-04 1.47386940825E-04 1.50102229002E-04 1.52863151496E-04 1.55670475269E-04 1.58524980173E-04 1.61427459164E-04 1.64378718530E-04 1.67379578109E-04 1.70430871516E-04 1.73533446382E-04 1.76688164580E-04 1.79895902472E-04 1.83157551148E-04 1.86474016677E-04 1.89846220353E-04 1.93275098961E-04 1.96761605026E-04 2.00306707086E-04 2.03911389957E-04 2.07576655009E-04 2.11303520441E-04 2.15093021568E-04 2.18946211106E-04 2.22864159466E-04 2.26847955050E-04 2.30898704556E-04 2.35017533281E-04 2.39205585439E-04 2.43464024477E-04 2.47794033396E-04 2.52196815084E-04 2.56673592647E-04 2.61225609750E-04 2.65854130965E-04 2.70560442117E-04 2.75345850648E-04 2.80211685976E-04 2.85159299865E-04 2.90190066803E-04 2.95305384382E-04 3.00506673688E-04 3.05795379694E-04 3.11172971666E-04 3.16640943564E-04 3.22200814467E-04 3.27854128988E-04 3.33602457705E-04 3.39447397600E-04 3.45390572502E-04 3.51433633537E-04 3.57578259590E-04 3.63826157770E-04 3.70179063884E-04 3.76638742922E-04 3.83206989548E-04 3.89885628595E-04 3.96676515579E-04 4.03581537211E-04 4.10602611921E-04 4.17741690397E-04 4.25000756120E-04 4.32381825924E-04 4.39886950552E-04 4.47518215226E-04 4.55277740234E-04 4.63167681511E-04 4.71190231245E-04 4.79347618487E-04 4.87642109769E-04 4.96076009735E-04 5.04651661787E-04 5.13371448731E-04 5.22237793446E-04 5.31253159556E-04 5.40420052114E-04 5.49741018307E-04 5.59218648157E-04 5.68855575247E-04 5.78654477456E-04 5.88618077700E-04 5.98749144696E-04 6.09050493732E-04 6.19524987449E-04 6.30175536643E-04 6.41005101073E-04 6.52016690288E-04 6.63213364468E-04 6.74598235272E-04 6.86174466713E-04 6.97945276034E-04 7.09913934609E-04 7.22083768857E-04 7.34458161168E-04 7.47040550846E-04 7.59834435074E-04 7.72843369885E-04 7.86070971160E-04 7.99520915632E-04 8.13196941922E-04 8.27102851572E-04 8.41242510120E-04 8.55619848170E-04 8.70238862497E-04 8.85103617164E-04 9.00218244657E-04 9.15586947042E-04 9.31213997142E-04 9.47103739732E-04 9.63260592755E-04 9.79689048560E-04 9.96393675163E-04 1.01337911752E-03 1.03065009885E-03 1.04821142191E-03 1.06606797041E-03 1.08422471033E-03 1.10268669134E-03 1.12145904820E-03 1.14054700223E-03 1.15995586274E-03 1.17969102857E-03 1.19975798954E-03 1.22016232807E-03 1.24090972069E-03 1.26200593970E-03 1.28345685472E-03 1.30526843440E-03 1.32744674810E-03 1.34999796757E-03 1.37292836872E-03 1.39624433339E-03 1.41995235113E-03 1.44405902107E-03 1.46857105375E-03 1.49349527306E-03 1.51883861814E-03 1.54460814535E-03 1.57081103028E-03 1.59745456980E-03 1.62454618411E-03 1.65209341884E-03 1.68010394724E-03 1.70858557232E-03 1.73754622910E-03 1.76699398685E-03 1.79693705141E-03 1.82738376755E-03 1.85834262130E-03 1.88982224245E-03 1.92183140695E-03 1.95437903950E-03 1.98747421604E-03 2.02112616643E-03 2.05534427703E-03 2.09013809346E-03 2.12551732336E-03 2.16149183911E-03 2.19807168081E-03 2.23526705906E-03 2.27308835801E-03 2.31154613834E-03 2.35065114034E-03 2.39041428700E-03 2.43084668726E-03 2.47195963921E-03 2.51376463339E-03 2.55627335620E-03 2.59949769328E-03 2.64344973303E-03 2.68814177020E-03 2.73358630945E-03 2.77979606912E-03 2.82678398495E-03 2.87456321395E-03 2.92314713830E-03 2.97254936937E-03 3.02278375173E-03 3.07386436739E-03 3.12580553994E-03 3.17862183892E-03 3.23232808422E-03 3.28693935052E-03 3.34247097194E-03 3.39893854665E-03 3.45635794166E-03 3.51474529767E-03 3.57411703405E-03 3.63448985387E-03 3.69588074910E-03 3.75830700587E-03 3.82178620984E-03 3.88633625171E-03 3.95197533285E-03 4.01872197099E-03 4.08659500611E-03 4.15561360641E-03 4.22579727441E-03 4.29716585321E-03 4.36973953285E-03 4.44353885686E-03 4.51858472888E-03 4.59489841951E-03 4.67250157328E-03 4.75141621576E-03 4.83166476084E-03 4.91327001821E-03 4.99625520098E-03 5.08064393347E-03 5.16646025924E-03 5.25372864923E-03 5.34247401016E-03 5.43272169311E-03 5.52449750228E-03 5.61782770402E-03 5.71273903604E-03 5.80925871686E-03 5.90741445552E-03 6.00723446147E-03 6.10874745480E-03 6.21198267670E-03 6.31696990010E-03 6.42373944079E-03 6.53232216859E-03 6.64274951904E-03 6.75505350525E-03 6.86926673013E-03 6.98542239894E-03 7.10355433224E-03 7.22369697910E-03 7.34588543075E-03 7.47015543462E-03 7.59654340872E-03 7.72508645652E-03 7.85582238219E-03 7.98878970630E-03 8.12402768201E-03 8.26157631175E-03 8.40147636434E-03 8.54376939269E-03 8.68849775204E-03 8.83570461867E-03 8.98543400938E-03 9.13773080135E-03 9.29264075283E-03 9.45021052436E-03 9.61048770075E-03 9.77352081370E-03 9.93935936527E-03 1.01080538520E-02 1.02796557898E-02 1.04542177402E-02 1.06317933363E-02 1.08124373110E-02 1.09962055255E-02 1.11831549983E-02 1.13733439364E-02 1.15668317666E-02 1.17636791684E-02 1.19639481078E-02 1.21677018725E-02 1.23750051084E-02 1.25859238570E-02 1.28005255952E-02 1.30188792752E-02 1.32410553667E-02 1.34671259010E-02 1.36971645156E-02 1.39312465017E-02 1.41694488529E-02 1.44118503157E-02 1.46585314421E-02 1.49095746444E-02 1.51650642521E-02 1.54250865703E-02 1.56897299417E-02 1.59590848098E-02 1.62332437855E-02 1.65123017159E-02 1.67963557561E-02 1.70855054432E-02 1.73798527748E-02 1.76795022890E-02 1.79845611486E-02 1.82951392287E-02 1.86113492075E-02 1.89333066615E-02 1.92611301638E-02 1.95949413869E-02 1.99348652104E-02 2.02810298319E-02 2.06335668834E-02 2.09926115526E-02 2.13583027090E-02 2.17307830354E-02 2.21101991650E-02 2.24967018242E-02 2.28904459816E-02 2.32915910033E-02 2.37003008146E-02 2.41167440691E-02 2.45410943240E-02 2.49735302241E-02 2.54142356928E-02 2.58634001316E-02 2.63212186280E-02 2.67878921722E-02 2.72636278833E-02 2.77486392450E-02 2.82431463513E-02 2.87473761627E-02 2.92615627735E-02 2.97859476902E-02 3.03207801219E-02 3.08663172828E-02 3.14228247079E-02 3.19905765816E-02 3.25698560805E-02 3.31609557302E-02 3.37641777776E-02 3.43798345782E-02 3.50082489999E-02 3.56497548434E-02 3.63046972800E-02 3.69734333074E-02 3.76563322239E-02 3.83537761226E-02 3.90661604046E-02 3.97938943138E-02 4.05374014929E-02 4.12971205603E-02 4.20735057120E-02 4.28670273448E-02 4.36781727051E-02 4.45074465618E-02 4.53553719059E-02 4.62224906750E-02 4.71093645061E-02 4.80165755153E-02 4.89447271064E-02 4.98944448082E-02 5.08663771415E-02 5.18611965164E-02 5.28796001599E-02 5.39223110756E-02 5.49900790339E-02 5.60836815952E-02 5.72039251644E-02 5.83516460789E-02 5.95277117282E-02 6.07330217069E-02 6.19685089992E-02 6.32351411964E-02 6.45339217457E-02 6.58658912302E-02 6.72321286788E-02 6.86337529067E-02 7.00719238821E-02 7.15478441214E-02 7.30627601081E-02 7.46179637348E-02 7.62147937655E-02 7.78546373162E-02 7.95389313487E-02 8.12691641765E-02 8.30468769768E-02 8.48736653046E-02 8.67511806050E-02 8.86811317151E-02 9.06652863526E-02 9.27054725812E-02 9.48035802470E-02 9.69615623754E-02 9.91814365214E-02 1.01465286061E-01 1.03815261411E-01 1.06233581171E-01 1.08722533168E-01 1.11284475385E-01 1.13921836777E-01 1.16637117924E-01 1.19432891544E-01 1.22311802802E-01 1.25276569432E-01 1.28329981617E-01 1.31474901628E-01 1.34714263174E-01 1.38051070448E-01 1.41488396826E-01 1.45029383204E-01 1.48677235912E-01 1.52435224195E-01 1.56306677196E-01 1.60294980420E-01 1.64403571618E-01 1.68635936052E-01 1.72995601086E-01 1.77486130063E-01 1.82111115389E-01 1.86874170788E-01 1.91778922661E-01 1.96829000474E-01 2.02028026130E-01 2.07379602236E-01 2.12887299210E-01 2.18554641140E-01 2.24385090338E-01 2.30382030493E-01 2.36548748362E-01 2.42888413902E-01 2.49404058787E-01 2.56098553204E-01 2.62974580875E-01 2.70034612216E-01 2.77280875556E-01 2.84715326370E-01 2.92339614439E-01 3.00155048907E-01 3.08162561181E-01 3.16362665651E-01 3.24755418224E-01 3.33340372679E-01 3.42116534881E-01 3.51082314922E-01 3.60235477303E-01 3.69573089292E-01 3.79091467671E-01 3.88786124127E-01 3.98651709619E-01 4.08681958136E-01 4.18869630338E-01 4.29206457701E-01 4.39683087861E-01 4.50289032017E-01 4.61012615371E-01 4.71840931704E-01 4.82759803374E-01 4.93753748126E-01 5.04805954268E-01 5.15898265851E-01 5.27011179596E-01 5.38123855325E-01 5.49214141599E-01 5.60258618123E-01 5.71232656177E-01 5.82110497884E-01 5.92865354420E-01 6.03469522333E-01 6.13894515896E-01 6.24111211810E-01 6.34090000655E-01 6.43800937220E-01 6.53213879388E-01 6.62298602757E-01 6.71024876066E-01 6.79362481382E-01 6.87281163865E-01 6.94750500376E-01 7.01739686508E-01 7.08217261296E-01 7.14150822949E-01 7.19506844690E-01 7.24250787537E-01 7.28347841255E-01 7.31764826257E-01 7.34474086489E-01 7.36460099455E-01 7.37719946338E-01 7.38253993666E-01 7.38064266090E-01 7.37154424263E-01 7.35529771370E-01 7.33197249041E-01 7.30165426992E-01 7.26444484726E-01 7.22046186268E-01 7.16983846594E-01 7.11272291344E-01 7.04927808646E-01 6.97968095038E-01 6.90412194386E-01 6.82280431970E-01 6.73594342643E-01 6.64376595304E-01 6.54650912574E-01 6.44441987884E-01 6.33775398851E-01 6.22677519071E-01 6.11175427205E-01 5.99296815347E-01 5.87069895601E-01 5.74523306657E-01 5.61686019390E-01 5.48587243042E-01 5.35256331114E-01 5.21722688321E-01 5.08015677863E-01 4.94164530122E-01 4.80198252235E-01 4.66145539414E-01 4.52034687682E-01 4.37893508704E-01 4.23749246627E-01 4.09628497434E-01 3.95557131013E-01 3.81560216309E-01 3.67661950017E-01 3.53885589101E-01 3.40253387808E-01 3.26786539361E-01 3.13505123175E-01 3.00428057632E-01 2.87573059337E-01 2.74956608719E-01 2.62593922864E-01 2.50498935235E-01 2.38684283036E-01 2.27161301647E-01 2.15940026699E-01 2.05029203004E-01 1.94436300688E-01 1.84167537562E-01 1.74227907906E-01 1.64621216556E-01 1.55350118336E-01 1.46416161656E-01 1.37819836248E-01 1.29560623847E-01 1.21637051758E-01 1.14046748183E-01 1.06786499233E-01 9.98523066228E-02 9.32394459775E-02 8.69425249006E-02 8.09555407497E-02 7.52719374350E-02 6.98846612224E-02 6.47862150090E-02 5.99687111025E-02 5.54239221144E-02 5.11433300488E-02 4.71181733220E-02 4.33394918356E-02 3.97981699444E-02 3.64849774642E-02 3.33906086371E-02 3.05057192028E-02 2.78209615346E-02 2.53270179713E-02 2.30146323135E-02 2.08746395808E-02 1.88979939879E-02 1.70757951908E-02 1.53993127448E-02 1.38600087826E-02 1.24495588411E-02 1.11598708188E-02 9.98310199017E-03 8.91167405220E-03 7.93828614531E-03 7.05592583513E-03 6.25787802880E-03 5.53773183877E-03 4.88938540783E-03 4.30704874409E-03 3.78524462209E-03 3.31880763550E-03 2.90288149668E-03 2.53291470075E-03 2.20465468016E-03 1.91414059108E-03 1.65769487772E-03 1.43191376899E-03 1.23365686228E-03 1.06003595126E-03 9.08403250849E-04 7.76339168948E-04 6.61639767545E-04 5.62304048338E-04 4.76521188157E-04 4.02657839501E-04 3.39245600085E-04 2.84968743918E-04 2.38652294398E-04 1.99250508244E-04 1.65835827343E-04 1.37588344412E-04 1.13785817641E-04 9.37942594118E-05 7.70591148996E-05 6.30970378652E-05 5.14882633100E-05 4.18695699540E-05 3.39278196488E-05 2.73940558952E-05 2.20381395465E-05 1.76638965081E-05 1.41047497496E-05 1.12198061581E-05 8.89036763046E-06 7.01683524671E-06 5.51597533161E-06 4.31851652806E-06 3.36704736580E-06 2.61418842925E-06 2.02100641492E-06 1.55564753777E-06 1.19216519643E-06 9.09519120783E-07 6.90725129938E-07 5.22136426183E-07 3.92839122618E-07 2.94146421736E-07 2.19177509614E-07 1.62508789297E-07 1.19886535931E-07 8.79914076868E-08 6.42464862173E-08 4.66616471702E-08 3.37080763267E-08 2.42176535830E-08 1.73027301044E-08 1.22925296538E-08 8.68302023778E-09 6.09763427328E-09 4.25667213562E-09 2.95361291075E-09 2.03688496751E-09 1.39592480838E-09 9.50582335325E-10 6.43120469671E-10 4.32212727482E-10 2.88469040758E-10 1.91122416811E-10 1.25590965226E-10 8.16948658357E-11 5.23589475853E-11 3.26711292875E-11 1.91969569006E-11 9.47222134078E-12 1.60985668116E-12 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 3P 1 2.00 Wavefunction 0.00000000000E+00 4.27730494981E-13 1.73979711363E-12 3.98079331660E-12 7.19706975311E-12 1.14367979502E-11 1.67500362299E-11 2.31887979320E-11 3.08071220197E-11 3.96611461525E-11 4.98091823098E-11 6.13117950529E-11 7.42318825166E-11 8.86347602241E-11 1.04588247822E-10 1.22162758835E-10 1.41431393548E-10 1.62470035115E-10 1.85357449013E-10 2.10175385955E-10 2.37008688374E-10 2.65945400612E-10 2.97076882924E-10 3.30497929454E-10 3.66306890287E-10 4.04605797745E-10 4.45500497052E-10 4.89100781536E-10 5.35520532506E-10 5.84877863974E-10 6.37295272385E-10 6.92899791533E-10 7.51823152827E-10 8.14201951105E-10 8.80177816171E-10 9.49897590269E-10 1.02351351168E-09 1.10118340465E-09 1.18307087590E-09 1.26934551789E-09 1.36018311912E-09 1.45576588164E-09 1.55628264612E-09 1.66192912461E-09 1.77290814141E-09 1.88942988213E-09 2.01171215139E-09 2.13998063942E-09 2.27446919776E-09 2.41542012448E-09 2.56308445926E-09 2.71772228853E-09 2.87960306117E-09 3.04900591505E-09 3.22622001477E-09 3.41154490100E-09 3.60529085189E-09 3.80777925680E-09 4.01934300289E-09 4.24032687506E-09 4.47108796947E-09 4.71199612141E-09 4.96343434771E-09 5.22579930441E-09 5.49950176013E-09 5.78496708556E-09 6.08263575992E-09 6.39296389458E-09 6.71642377475E-09 7.05350441970E-09 7.40471216214E-09 7.77057124749E-09 8.15162445362E-09 8.54843373186E-09 8.96158086990E-09 9.39166817744E-09 9.83931919522E-09 1.03051794284E-08 1.07899171050E-08 1.12942239603E-08 1.18188160477E-08 1.23644345782E-08 1.29318467876E-08 1.35218468340E-08 1.41352567255E-08 1.47729272801E-08 1.54357391180E-08 1.61246036878E-08 1.68404643284E-08 1.75842973660E-08 1.83571132497E-08 1.91599577254E-08 1.99939130495E-08 2.08600992447E-08 2.17596753978E-08 2.26938410027E-08 2.36638373490E-08 2.46709489570E-08 2.57165050634E-08 2.68018811559E-08 2.79285005618E-08 2.90978360895E-08 3.03114117262E-08 3.15708043947E-08 3.28776457680E-08 3.42336241479E-08 3.56404864060E-08 3.71000399920E-08 3.86141550096E-08 4.01847663639E-08 4.18138759812E-08 4.35035551051E-08 4.52559466709E-08 4.70732677597E-08 4.89578121379E-08 5.09119528818E-08 5.29381450922E-08 5.50389287011E-08 5.72169313748E-08 5.94748715144E-08 6.18155613603E-08 6.42419102007E-08 6.67569276903E-08 6.93637272819E-08 7.20655297745E-08 7.48656669824E-08 7.77675855288E-08 8.07748507693E-08 8.38911508480E-08 8.71203008923E-08 9.04662473502E-08 9.39330724748E-08 9.75249989620E-08 1.01246394746E-07 1.05101777956E-07 1.09095822046E-07 1.13233361094E-07 1.17519395284E-07 1.21959096573E-07 1.26557814556E-07 1.31321082521E-07 1.36254623718E-07 1.41364357837E-07 1.46656407710E-07 1.52137106235E-07 1.57813003540E-07 1.63690874393E-07 1.69777725853E-07 1.76080805195E-07 1.82607608092E-07 1.89365887087E-07 1.96363660342E-07 2.03609220689E-07 2.11111144992E-07 2.18878303820E-07 2.26919871456E-07 2.35245336240E-07 2.43864511266E-07 2.52787545445E-07 2.62024934937E-07 2.71587534980E-07 2.81486572115E-07 2.91733656826E-07 3.02340796616E-07 3.13320409515E-07 3.24685338063E-07 3.36448863752E-07 3.48624721970E-07 3.61227117445E-07 3.74270740221E-07 3.87770782170E-07 4.01742954065E-07 4.16203503240E-07 4.31169231841E-07 4.46657515701E-07 4.62686323854E-07 4.79274238720E-07 4.96440476956E-07 5.14204911041E-07 5.32588091569E-07 5.51611270315E-07 5.71296424081E-07 5.91666279346E-07 6.12744337758E-07 6.34554902489E-07 6.57123105487E-07 6.80474935653E-07 7.04637267969E-07 7.29637893622E-07 7.55505551148E-07 7.82269958629E-07 8.09961846990E-07 8.38612994423E-07 8.68256261974E-07 8.98925630347E-07 9.30656237953E-07 9.63484420246E-07 9.97447750403E-07 1.03258508138E-06 1.06893658938E-06 1.10654381884E-06 1.14544972888E-06 1.18569874141E-06 1.22733679077E-06 1.27041137513E-06 1.31497160965E-06 1.36106828132E-06 1.40875390585E-06 1.45808278629E-06 1.50911107379E-06 1.56189683038E-06 1.61650009381E-06 1.67298294469E-06 1.73140957586E-06 1.79184636412E-06 1.85436194436E-06 1.91902728629E-06 1.98591577367E-06 2.05510328630E-06 2.12666828477E-06 2.20069189810E-06 2.27725801430E-06 2.35645337406E-06 2.43836766759E-06 2.52309363478E-06 2.61072716868E-06 2.70136742259E-06 2.79511692070E-06 2.89208167252E-06 2.99237129120E-06 3.09609911586E-06 3.20338233799E-06 3.31434213232E-06 3.42910379190E-06 3.54779686797E-06 3.67055531442E-06 3.79751763724E-06 3.92882704900E-06 4.06463162856E-06 4.20508448626E-06 4.35034393464E-06 4.50057366496E-06 4.65594292976E-06 4.81662673154E-06 4.98280601791E-06 5.15466788330E-06 5.33240577752E-06 5.51621972145E-06 5.70631652994E-06 5.90291004237E-06 6.10622136100E-06 6.31647909733E-06 6.53391962695E-06 6.75878735287E-06 6.99133497796E-06 7.23182378646E-06 7.48052393514E-06 7.73771475431E-06 8.00368505899E-06 8.27873347075E-06 8.56316875028E-06 8.85731014143E-06 9.16148772677E-06 9.47604279530E-06 9.80132822255E-06 1.01377088636E-05 1.04855619596E-05 1.08452775576E-05 1.12172589452E-05 1.16019230995E-05 1.19997011515E-05 1.24110388661E-05 1.28363971386E-05 1.32762525077E-05 1.37310976862E-05 1.42014421095E-05 1.46878125029E-05 1.51907534678E-05 1.57108280880E-05 1.62486185567E-05 1.68047268244E-05 1.73797752691E-05 1.79744073888E-05 1.85892885182E-05 1.92251065687E-05 1.98825727944E-05 2.05624225836E-05 2.12654162772E-05 2.19923400150E-05 2.27440066101E-05 2.35212564541E-05 2.43249584518E-05 2.51560109881E-05 2.60153429278E-05 2.69039146491E-05 2.78227191121E-05 2.87727829636E-05 2.97551676794E-05 3.07709707451E-05 3.18213268774E-05 3.29074092861E-05 3.40304309794E-05 3.51916461133E-05 3.63923513869E-05 3.76338874843E-05 3.89176405666E-05 4.02450438133E-05 4.16175790163E-05 4.30367782285E-05 4.45042254672E-05 4.60215584766E-05 4.75904705483E-05 4.92127124052E-05 5.08900941484E-05 5.26244872699E-05 5.44178267339E-05 5.62721131285E-05 5.81894148905E-05 6.01718706054E-05 6.22216913850E-05 6.43411633265E-05 6.65326500539E-05 6.87985953460E-05 7.11415258540E-05 7.35640539097E-05 7.60688804305E-05 7.86587979217E-05 8.13366935810E-05 8.41055525081E-05 8.69684610230E-05 8.99286100967E-05 9.29892988983E-05 9.61539384620E-05 9.94260554786E-05 1.02809296215E-04 1.06307430568E-04 1.09924356251E-04 1.13664103130E-04 1.17530837700E-04 1.21528867714E-04 1.25662646972E-04 1.29936780270E-04 1.34356028516E-04 1.38925314020E-04 1.43649725963E-04 1.48534526053E-04 1.53585154370E-04 1.58807235409E-04 1.64206584331E-04 1.69789213418E-04 1.75561338760E-04 1.81529387151E-04 1.87700003233E-04 1.94080056877E-04 2.00676650810E-04 2.07497128505E-04 2.14549082335E-04 2.21840362010E-04 2.29379083287E-04 2.37173636985E-04 2.45232698302E-04 2.53565236447E-04 2.62180524600E-04 2.71088150201E-04 2.80298025601E-04 2.89820399059E-04 2.99665866124E-04 3.09845381388E-04 3.20370270650E-04 3.31252243484E-04 3.42503406230E-04 3.54136275433E-04 3.66163791729E-04 3.78599334201E-04 3.91456735223E-04 4.04750295806E-04 4.18494801460E-04 4.32705538593E-04 4.47398311466E-04 4.62589459718E-04 4.78295876486E-04 4.94535027134E-04 5.11324968618E-04 5.28684369501E-04 5.46632530648E-04 5.65189406617E-04 5.84375627772E-04 6.04212523145E-04 6.24722144066E-04 6.45927288594E-04 6.67851526769E-04 6.90519226715E-04 7.13955581632E-04 7.38186637684E-04 7.63239322838E-04 7.89141476674E-04 8.15921881193E-04 8.43610292669E-04 8.72237474574E-04 9.01835231607E-04 9.32436444874E-04 9.64075108247E-04 9.96786365953E-04 1.03060655142E-03 1.06557322744E-03 1.10172522766E-03 1.13910269950E-03 1.17774714850E-03 1.21770148412E-03 1.25901006717E-03 1.30171875871E-03 1.34587497069E-03 1.39152771824E-03 1.43872767375E-03 1.48752722268E-03 1.53798052139E-03 1.59014355671E-03 1.64407420770E-03 1.69983230931E-03 1.75747971832E-03 1.81708038133E-03 1.87870040514E-03 1.94240812943E-03 2.00827420188E-03 2.07637165576E-03 2.14677599017E-03 2.21956525287E-03 2.29482012595E-03 2.37262401428E-03 2.45306313692E-03 2.53622662161E-03 2.62220660230E-03 2.71109832003E-03 2.80300022700E-03 2.89801409427E-03 2.99624512281E-03 3.09780205842E-03 3.20279731026E-03 3.31134707341E-03 3.42357145540E-03 3.53959460691E-03 3.65954485674E-03 3.78355485127E-03 3.91176169836E-03 4.04430711609E-03 4.18133758622E-03 4.32300451273E-03 4.46946438551E-03 4.62087894929E-03 4.77741537811E-03 4.93924645537E-03 5.10655075977E-03 5.27951285708E-03 5.45832349823E-03 5.64317982361E-03 5.83428557396E-03 6.03185130794E-03 6.23609462660E-03 6.44724040497E-03 6.66552103094E-03 6.89117665161E-03 7.12445542744E-03 7.36561379421E-03 7.61491673317E-03 7.87263804955E-03 8.13906065963E-03 8.41447688656E-03 8.69918876523E-03 8.99350835639E-03 9.29775807015E-03 9.61227099927E-03 9.93739126227E-03 1.02734743567E-02 1.06208875228E-02 1.09800101176E-02 1.13512340001E-02 1.17349639269E-02 1.21316179599E-02 1.25416278844E-02 1.29654396395E-02 1.34035137601E-02 1.38563258307E-02 1.43243669516E-02 1.48081442169E-02 1.53081812053E-02 1.58250184833E-02 1.63592141206E-02 1.69113442187E-02 1.74820034519E-02 1.80718056204E-02 1.86813842174E-02 1.93113930072E-02 1.99625066168E-02 2.06354211395E-02 2.13308547505E-02 2.20495483344E-02 2.27922661241E-02 2.35597963509E-02 2.43529519056E-02 2.51725710088E-02 2.60195178915E-02 2.68946834841E-02 2.77989861136E-02 2.87333722071E-02 2.96988170020E-02 3.06963252608E-02 3.17269319887E-02 3.27917031539E-02 3.38917364078E-02 3.50281618040E-02 3.62021425133E-02 3.74148755338E-02 3.86675923922E-02 3.99615598352E-02 4.12980805068E-02 4.26784936091E-02 4.41041755438E-02 4.55765405291E-02 4.70970411903E-02 4.86671691180E-02 5.02884553898E-02 5.19624710520E-02 5.36908275542E-02 5.54751771323E-02 5.73172131335E-02 5.92186702779E-02 6.11813248485E-02 6.32069948040E-02 6.52975398058E-02 6.74548611517E-02 6.96809016084E-02 7.19776451326E-02 7.43471164736E-02 7.67913806451E-02 7.93125422589E-02 8.19127447071E-02 8.45941691843E-02 8.73590335358E-02 9.02095909219E-02 9.31481282844E-02 9.61769646019E-02 9.92984489217E-02 1.02514958152E-01 1.05828894601E-01 1.09242683245E-01 1.12758768709E-01 1.16379611949E-01 1.20107686597E-01 1.23945474977E-01 1.27895463741E-01 1.31960139122E-01 1.36141981761E-01 1.40443461096E-01 1.44867029257E-01 1.49415114448E-01 1.54090113775E-01 1.58894385449E-01 1.63830240343E-01 1.68899932819E-01 1.74105650763E-01 1.79449504752E-01 1.84933516263E-01 1.90559604826E-01 1.96329574010E-01 2.02245096119E-01 2.08307695468E-01 2.14518730082E-01 2.20879371679E-01 2.27390583749E-01 2.34053097578E-01 2.40867386032E-01 2.47833634941E-01 2.54951711928E-01 2.62221132557E-01 2.69641023713E-01 2.77210084189E-01 2.84926542519E-01 2.92788112229E-01 3.00791944786E-01 3.08934580697E-01 3.17211899446E-01 3.25619069149E-01 3.34150497142E-01 3.42799783003E-01 3.51559675867E-01 3.60422038261E-01 3.69377819015E-01 3.78417038147E-01 3.87528786806E-01 3.96701245446E-01 4.05921723201E-01 4.15176720931E-01 4.24452019385E-01 4.33732792276E-01 4.43003741645E-01 4.52249249426E-01 4.61453534625E-01 4.70600799750E-01 4.79675343320E-01 4.88661607662E-01 4.97544123714E-01 5.06307308638E-01 5.14935070586E-01 5.23410182382E-01 5.31713409492E-01 5.39822428663E-01 5.47710669109E-01 5.55346373698E-01 5.62692450982E-01 5.69708125280E-01 5.76354071146E-01 5.82602965220E-01 5.88442580725E-01 5.93863751309E-01 5.98858004151E-01 6.03417567105E-01 6.07535409621E-01 6.11205272174E-01 6.14421693602E-01 6.17180034873E-01 6.19476499861E-01 6.21308151851E-01 6.22672926839E-01 6.23569642415E-01 6.23998003656E-01 6.23958604792E-01 6.23452928305E-01 6.22483340168E-01 6.21053082994E-01 6.19166265751E-01 6.16827851837E-01 6.14043644138E-01 6.10820268811E-01 6.07165156430E-01 6.03086522105E-01 5.98593343261E-01 5.93695336535E-01 5.88402932522E-01 5.82727249647E-01 5.76680065974E-01 5.70273790019E-01 5.63521429490E-01 5.56436558777E-01 5.49033284282E-01 5.41326208186E-01 5.33330389926E-01 5.25061305785E-01 5.16534806129E-01 5.07767070515E-01 4.98774560534E-01 4.89573970487E-01 4.80182176136E-01 4.70616181551E-01 4.60893064677E-01 4.51029921621E-01 4.41043810626E-01 4.30951695704E-01 4.20770391182E-01 4.10516507066E-01 4.00206396651E-01 3.89856106163E-01 3.79481327920E-01 3.69097356606E-01 3.58719050107E-01 3.48360794251E-01 3.38036472782E-01 3.27759441677E-01 3.17542508931E-01 3.07397918714E-01 2.97337340832E-01 2.87371864229E-01 2.77511995256E-01 2.67767659374E-01 2.58148206829E-01 2.48662420935E-01 2.39318529380E-01 2.30124217189E-01 2.21086641686E-01 2.12212448129E-01 2.03507786303E-01 1.94978326855E-01 1.86629277618E-01 1.78465398852E-01 1.70491017658E-01 1.62710040674E-01 1.55125965368E-01 1.47741889240E-01 1.40560517340E-01 1.33584167660E-01 1.26814774911E-01 1.20253892477E-01 1.13902693163E-01 1.07761968737E-01 1.01832128952E-01 9.61132001752E-02 9.06048243398E-02 8.53062583989E-02 8.02163749229E-02 7.53336640262E-02 7.06562371178E-02 6.61818325947E-02 6.19078238028E-02 5.78312292704E-02 5.39487253646E-02 5.02566612547E-02 4.67510761728E-02 4.34277187535E-02 4.02820683162E-02 3.73093578006E-02 3.45045981337E-02 3.18626037035E-02 2.93780186751E-02 2.70453438196E-02 2.48589635862E-02 2.28131731091E-02 2.09022048997E-02 1.91202549583E-02 1.74615080902E-02 1.59201622140E-02 1.44904514941E-02 1.31666681395E-02 1.19431827519E-02 1.08144631193E-02 9.77509138807E-03 8.81977955828E-03 7.94338328050E-03 7.14091394352E-03 6.40754906735E-03 5.73864102901E-03 5.12972416572E-03 4.57652031160E-03 4.07494283631E-03 3.62109926253E-03 3.21129254766E-03 2.84202112019E-03 2.50997776666E-03 2.21204746719E-03 1.94530428005E-03 1.70700737558E-03 1.49459631955E-03 1.30568570421E-03 1.13805922289E-03 9.89663280685E-04 8.58600229773E-04 7.43121313683E-04 6.41619399590E-04 5.52621572658E-04 4.74781651349E-04 4.06872630408E-04 3.47779438470E-04 2.96491512862E-04 2.52095599904E-04 2.13768753608E-04 1.80771554924E-04 1.52441579553E-04 1.28187137325E-04 1.07481301335E-04 8.98562405472E-05 7.48978653529E-05 6.22407916854E-05 5.15636257483E-05 4.25845682081E-05 3.50573338518E-05 2.87673802008E-05 2.35284364182E-05 1.91793220160E-05 1.55810433660E-05 1.26141548219E-05 1.01763703458E-05 8.18041089586E-06 6.55207242825E-06 5.22849919701E-06 4.15664705799E-06 3.29192168287E-06 2.59697693985E-06 2.04065917642E-06 1.59708372260E-06 1.24483060109E-06 9.66247160991E-07 7.46846127961E-07 5.74788367127E-07 4.40440471083E-07 3.35998100665E-07 2.55166808710E-07 1.92892857181E-07 1.45137287630E-07 1.08687217634E-07 8.09990066177E-08 6.00685600632E-08 4.43246193275E-08 3.25414142219E-08 2.37675372208E-08 1.72683325533E-08 1.24794820535E-08 8.96981449767E-09 6.41167110837E-09 4.55742302495E-09 3.22096904143E-09 2.26324144842E-09 1.58091875428E-09 1.09768759648E-09 7.57518802279E-10 5.19524975002E-10 3.54052023822E-10 2.39727236157E-10 1.61243991291E-10 1.07709971222E-10 7.14234546268E-11 4.69724805555E-11 3.05756297678E-11 1.96019840625E-11 1.22223849517E-11 7.15512630380E-12 3.47717573818E-12 4.77170030404E-13 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 5.87941537287E-12 2.39145677369E-11 5.47184212841E-11 9.89280938294E-11 1.57205732257E-10 2.30239418595E-10 3.18744107771E-10 4.23462598138E-10 5.45166535901E-10 6.84657454609E-10 8.42767850912E-10 1.02036229784E-09 1.21833859691E-09 1.43762897029E-09 1.67920129462E-09 1.94406037765E-09 2.23324927936E-09 2.54785067901E-09 2.88898828972E-09 3.25782832220E-09 3.65558099928E-09 4.08350212309E-09 4.54289469657E-09 5.03511060126E-09 5.56155233323E-09 6.12367479925E-09 6.72298717511E-09 7.36105482836E-09 8.03950130762E-09 8.76001040072E-09 9.52432826402E-09 1.03342656255E-08 1.11917000638E-08 1.20985783663E-08 1.30569189684E-08 1.40688144773E-08 1.51364342828E-08 1.62620272580E-08 1.74479245538E-08 1.86965424891E-08 2.00103855413E-08 2.13920494393E-08 2.28442243633E-08 2.43696982557E-08 2.59713602442E-08 2.76522041848E-08 2.94153323255E-08 3.12639590966E-08 3.32014150308E-08 3.52311508196E-08 3.73567415072E-08 3.95818908307E-08 4.19104357075E-08 4.43463508785E-08 4.68937537104E-08 4.95569091619E-08 5.23402349225E-08 5.52483067256E-08 5.82858638459E-08 6.14578147837E-08 6.47692431460E-08 6.82254137278E-08 7.18317788030E-08 7.55939846310E-08 7.95178781857E-08 8.36095141155E-08 8.78751619426E-08 9.23213135077E-08 9.69546906706E-08 1.01782253275E-07 1.06811207384E-07 1.12049013800E-07 1.17503396877E-07 1.23182353629E-07 1.29094163158E-07 1.35247396398E-07 1.41650926197E-07 1.48313937742E-07 1.55245939336E-07 1.62456773557E-07 1.69956628779E-07 1.77756051107E-07 1.85865956706E-07 1.94297644554E-07 2.03062809639E-07 2.12173556592E-07 2.21642413804E-07 2.31482348008E-07 2.41706779372E-07 2.52329597097E-07 2.63365175559E-07 2.74828390989E-07 2.86734638735E-07 2.99099851106E-07 3.11940515825E-07 3.25273695113E-07 3.39117045430E-07 3.53488837875E-07 3.68407979300E-07 3.83894034129E-07 3.99967246930E-07 4.16648565753E-07 4.33959666266E-07 4.51922976714E-07 4.70561703725E-07 4.89899859001E-07 5.09962286916E-07 5.30774693054E-07 5.52363673721E-07 5.74756746464E-07 5.97982381626E-07 6.22070034982E-07 6.47050181477E-07 6.72954350125E-07 6.99815160090E-07 7.27666357996E-07 7.56542856509E-07 7.86480774233E-07 8.17517476964E-07 8.49691620352E-07 8.83043194005E-07 9.17613567109E-07 9.53445535589E-07 9.90583370882E-07 1.02907287037E-06 1.06896140952E-06 1.11029799581E-06 1.15313332450E-06 1.19751983626E-06 1.24351177680E-06 1.29116525851E-06 1.34053832421E-06 1.39169101305E-06 1.44468542865E-06 1.49958580962E-06 1.55645860234E-06 1.61537253639E-06 1.67639870240E-06 1.73961063264E-06 1.80508438428E-06 1.87289862555E-06 1.94313472479E-06 2.01587684249E-06 2.09121202658E-06 2.16923031081E-06 2.25002481659E-06 2.33369185820E-06 2.42033105169E-06 2.51004542736E-06 2.60294154614E-06 2.69912961988E-06 2.79872363579E-06 2.90184148501E-06 3.00860509568E-06 3.11914057039E-06 3.23357832841E-06 3.35205325267E-06 3.47470484184E-06 3.60167736743E-06 3.73312003636E-06 3.86918715899E-06 4.01003832285E-06 4.15583857228E-06 4.30675859423E-06 4.46297491024E-06 4.62467007508E-06 4.79203288205E-06 4.96525857527E-06 5.14454906918E-06 5.33011317553E-06 5.52216683801E-06 5.72093337487E-06 5.92664372985E-06 6.13953673147E-06 6.35985936133E-06 6.58786703132E-06 6.82382387035E-06 7.06800302083E-06 7.32068694512E-06 7.58216774246E-06 7.85274747665E-06 8.13273851480E-06 8.42246387762E-06 8.72225760163E-06 9.03246511355E-06 9.35344361752E-06 9.68556249539E-06 1.00292037206E-05 1.03847622861E-05 1.07526466469E-05 1.11332791774E-05 1.15270966443E-05 1.19345506960E-05 1.23561083678E-05 1.27922526050E-05 1.32434828031E-05 1.37103153670E-05 1.41932842883E-05 1.46929417433E-05 1.52098587102E-05 1.57446256080E-05 1.62978529564E-05 1.68701720588E-05 1.74622357082E-05 1.80747189163E-05 1.87083196688E-05 1.93637597050E-05 2.00417853243E-05 2.07431682202E-05 2.14687063426E-05 2.22192247887E-05 2.29955767251E-05 2.37986443402E-05 2.46293398298E-05 2.54886064149E-05 2.63774193955E-05 2.72967872389E-05 2.82477527055E-05 2.92313940122E-05 3.02488260363E-05 3.13012015590E-05 3.23897125514E-05 3.35155915047E-05 3.46801128048E-05 3.58845941533E-05 3.71303980375E-05 3.84189332494E-05 3.97516564566E-05 4.11300738260E-05 4.25557427031E-05 4.40302733474E-05 4.55553307275E-05 4.71326363760E-05 4.87639703079E-05 5.04511730040E-05 5.21961474605E-05 5.40008613095E-05 5.58673490099E-05 5.77977141133E-05 5.97941316059E-05 6.18588503309E-05 6.39941954912E-05 6.62025712380E-05 6.84864633467E-05 7.08484419830E-05 7.32911645632E-05 7.58173787104E-05 7.84299253116E-05 8.11317416774E-05 8.39258648092E-05 8.68154347762E-05 8.98036982075E-05 9.28940119010E-05 9.60898465553E-05 9.93947906277E-05 1.02812554322E-04 1.06346973710E-04 1.10002014996E-04 1.13781778923E-04 1.17690505322E-04 1.21732577829E-04 1.25912528747E-04 1.30235044079E-04 1.34704968730E-04 1.39327311886E-04 1.44107252570E-04 1.49050145391E-04 1.54161526482E-04 1.59447119642E-04 1.64912842683E-04 1.70564813991E-04 1.76409359309E-04 1.82453018749E-04 1.88702554039E-04 1.95164956012E-04 2.01847452355E-04 2.08757515608E-04 2.15902871443E-04 2.23291507210E-04 2.30931680784E-04 2.38831929697E-04 2.47001080585E-04 2.55448258949E-04 2.64182899245E-04 2.73214755312E-04 2.82553911155E-04 2.92210792078E-04 3.02196176207E-04 3.12521206387E-04 3.23197402479E-04 3.34236674080E-04 3.45651333652E-04 3.57454110108E-04 3.69658162840E-04 3.82277096222E-04 3.95324974599E-04 4.08816337773E-04 4.22766217012E-04 4.37190151586E-04 4.52104205864E-04 4.67524986973E-04 4.83469663052E-04 4.99955982114E-04 5.17002291527E-04 5.34627558157E-04 5.52851389174E-04 5.71694053545E-04 5.91176504254E-04 6.11320401241E-04 6.32148135125E-04 6.53682851687E-04 6.75948477191E-04 6.98969744516E-04 7.22772220176E-04 7.47382332216E-04 7.72827399034E-04 7.99135659157E-04 8.26336301991E-04 8.54459499588E-04 8.83536439454E-04 9.13599358435E-04 9.44681577717E-04 9.76817538968E-04 1.01004284167E-03 1.04439428164E-03 1.07990989089E-03 1.11662897867E-03 1.15459217394E-03 1.19384146916E-03 1.23442026557E-03 1.27637341987E-03 1.31974729243E-03 1.36458979708E-03 1.41095045248E-03 1.45888043513E-03 1.50843263415E-03 1.55966170772E-03 1.61262414137E-03 1.66737830819E-03 1.72398453083E-03 1.78250514559E-03 1.84300456844E-03 1.90554936323E-03 1.97020831198E-03 2.03705248735E-03 2.10615532753E-03 2.17759271326E-03 2.25144304744E-03 2.32778733712E-03 2.40670927801E-03 2.48829534168E-03 2.57263486538E-03 2.65982014459E-03 2.74994652848E-03 2.84311251821E-03 2.93941986819E-03 3.03897369044E-03 3.14188256207E-03 3.24825863591E-03 3.35821775449E-03 3.47187956741E-03 3.58936765202E-03 3.71080963780E-03 3.83633733420E-03 3.96608686228E-03 4.10019879005E-03 4.23881827167E-03 4.38209519060E-03 4.53018430675E-03 4.68324540769E-03 4.84144346410E-03 5.00494878937E-03 5.17393720354E-03 5.34859020171E-03 5.52909512675E-03 5.71564534670E-03 5.90844043660E-03 6.10768636510E-03 6.31359568565E-03 6.52638773252E-03 6.74628882159E-03 6.97353245592E-03 7.20835953625E-03 7.45101857633E-03 7.70176592317E-03 7.96086598214E-03 8.22859144705E-03 8.50522353501E-03 8.79105222615E-03 9.08637650821E-03 9.39150462574E-03 9.70675433407E-03 1.00324531577E-02 1.03689386535E-02 1.07165586775E-02 1.10756716565E-02 1.14466468637E-02 1.18298646971E-02 1.22257169627E-02 1.26346071601E-02 1.30569507710E-02 1.34931755508E-02 1.39437218218E-02 1.44090427685E-02 1.48896047342E-02 1.53858875178E-02 1.58983846714E-02 1.64276037968E-02 1.69740668415E-02 1.75383103920E-02 1.81208859643E-02 1.87223602914E-02 1.93433156053E-02 1.99843499128E-02 2.06460772656E-02 2.13291280203E-02 2.20341490902E-02 2.27618041843E-02 2.35127740350E-02 2.42877566095E-02 2.50874673054E-02 2.59126391278E-02 2.67640228447E-02 2.76423871197E-02 2.85485186185E-02 2.94832220869E-02 3.04473203967E-02 3.14416545576E-02 3.24670836899E-02 3.35244849562E-02 3.46147534467E-02 3.57388020144E-02 3.68975610567E-02 3.80919782368E-02 3.93230181419E-02 4.05916618702E-02 4.18989065446E-02 4.32457647427E-02 4.46332638403E-02 4.60624452592E-02 4.75343636134E-02 4.90500857444E-02 5.06106896389E-02 5.22172632198E-02 5.38709030004E-02 5.55727125936E-02 5.73238010646E-02 5.91252811171E-02 6.09782671016E-02 6.28838728333E-02 6.48432092084E-02 6.68573816043E-02 6.89274870508E-02 7.10546111584E-02 7.32398247877E-02 7.54841804457E-02 7.77887083919E-02 8.01544124384E-02 8.25822654256E-02 8.50732043574E-02 8.76281251761E-02 9.02478771590E-02 9.29332569178E-02 9.56850019810E-02 9.85037839387E-02 1.01390201132E-01 1.04344770866E-01 1.07367921125E-01 1.10459981773E-01 1.13621175216E-01 1.16851606519E-01 1.20151252937E-01 1.23519952874E-01 1.26957394223E-01 1.30463102100E-01 1.34036425940E-01 1.37676525964E-01 1.41382358995E-01 1.45152663628E-01 1.48985944753E-01 1.52880457447E-01 1.56834190221E-01 1.60844847673E-01 1.64909832540E-01 1.69026227201E-01 1.73190774669E-01 1.77399859109E-01 1.81649485958E-01 1.85935261721E-01 1.90252373513E-01 1.94595568470E-01 1.98959133132E-01 2.03336872939E-01 2.07722091995E-01 2.12107573274E-01 2.16485559467E-01 2.20847734694E-01 2.25185207324E-01 2.29488494188E-01 2.33747506481E-01 2.37951537689E-01 2.42089253917E-01 2.46148687005E-01 2.50117230875E-01 2.53981641573E-01 2.57728041504E-01 2.61341928404E-01 2.64808189596E-01 2.68111122157E-01 2.71234459583E-01 2.74161405628E-01 2.76874675962E-01 2.79356548333E-01 2.81588921900E-01 2.83553386413E-01 2.85231301892E-01 2.86603889412E-01 2.87652333569E-01 2.88357897139E-01 2.88702048310E-01 2.88666600839E-01 2.88233867261E-01 2.87386825190E-01 2.86109296531E-01 2.84386139207E-01 2.82203450791E-01 2.79548783139E-01 2.76411366862E-01 2.72782344149E-01 2.68655008176E-01 2.64025046996E-01 2.58890789549E-01 2.53253451158E-01 2.47117375700E-01 2.40490271504E-01 2.33383438066E-01 2.25811980805E-01 2.17795011435E-01 2.09355832112E-01 2.00522102380E-01 1.91325989086E-01 1.81804300983E-01 1.71998611609E-01 1.61955376280E-01 1.51726051602E-01 1.41367228711E-01 1.30940794304E-01 1.20514136228E-01 1.10160412508E-01 9.99589037645E-02 8.99954682335E-02 8.03631151712E-02 7.11627051326E-02 6.25037730426E-02 5.45054505189E-02 4.72974357527E-02 4.10209206757E-02 3.58293346613E-02 3.18887010504E-02 2.93773283905E-02 2.84844765006E-02 2.94075573506E-02 3.23473693345E-02 3.75008503333E-02 4.50509185470E-02 5.51532273658E-02 6.79202104789E-02 8.34038161415E-02 1.01580093660E-01 1.22341696128E-01 1.45508977077E-01 1.70877515800E-01 1.98317189867E-01 2.27785177980E-01 2.59239790205E-01 2.92629317784E-01 3.27892071877E-01 3.64956535236E-01 4.03741609976E-01 4.44156966230E-01 4.86103515179E-01 5.29474007524E-01 5.74153777534E-01 6.20021612730E-01 6.66950740048E-01 7.14809851848E-01 7.63464095227E-01 8.12775864430E-01 8.62605262391E-01 9.12810062937E-01 9.63245139818E-01 1.01376140617E+00 1.06420453860E+00 1.11441382264E+00 1.16422155357E+00 1.21345324246E+00 1.26192873768E+00 1.30946406299E+00 1.35587369683E+00 1.40097291220E+00 1.44457995293E+00 1.48651787538E+00 1.52661606865E+00 1.56471146848E+00 1.60064956662E+00 1.63428525909E+00 1.66548361023E+00 1.69412055245E+00 1.72008356136E+00 1.74327231924E+00 1.76359938770E+00 1.78099078144E+00 1.79538622994E+00 1.80673954141E+00 1.81501881239E+00 1.82020663843E+00 1.82230018287E+00 1.82131113808E+00 1.81726557106E+00 1.81020365935E+00 1.80017931305E+00 1.78725969387E+00 1.77152463005E+00 1.75306594186E+00 1.73198667863E+00 1.70840028463E+00 1.68242969574E+00 1.65420638584E+00 1.62386936520E+00 1.59156415032E+00 1.55744170738E+00 1.52165738826E+00 1.48436986114E+00 1.44574005317E+00 1.40593010691E+00 1.36510236608E+00 1.32341839177E+00 1.28103802240E+00 1.23811847793E+00 1.19481351910E+00 1.15127266178E+00 1.10764045440E+00 1.06405581821E+00 1.02065145595E+00 9.77553328122E-01 9.34880200311E-01 8.92743260603E-01 8.51245808271E-01 8.10483012884E-01 7.70541743087E-01 7.31500464100E-01 6.93429201554E-01 6.56389570467E-01 6.20434865485E-01 5.85610210745E-01 5.51952764108E-01 5.19491973502E-01 4.88249878878E-01 4.58241456843E-01 4.29475000463E-01 4.01952530724E-01 3.75670231527E-01 3.50618904349E-01 3.26784434361E-01 3.04148264145E-01 2.82687867217E-01 2.62377217944E-01 2.43187250926E-01 2.25086307213E-01 2.08040561648E-01 1.92014429696E-01 1.76970949452E-01 1.62872138224E-01 1.49679320828E-01 1.37353429951E-01 1.25855277046E-01 1.15145794925E-01 1.05186251635E-01 9.59384374017E-02 8.73648250838E-02 7.94287063379E-02 7.20943045407E-02 6.53268668766E-02 5.90927370025E-02 5.33594107206E-02 4.80955762237E-02 4.32711412079E-02 3.88572483904E-02 3.48262814593E-02 3.11518628259E-02 2.78088448489E-02 2.47732956327E-02 2.20224806692E-02 1.95348411119E-02 1.72899695558E-02 1.52685838093E-02 1.34524991847E-02 1.18245995463E-02 1.03688073821E-02 9.07005296880E-03 7.91424273543E-03 6.88822681381E-03 5.97976581033E-03 5.17749677875E-03 4.47089842883E-03 3.85025559006E-03 3.30662300603E-03 2.83178854049E-03 2.41823592436E-03 2.05910718481E-03 1.74816493213E-03 1.47975468775E-03 1.24876745588E-03 1.05060273993E-03 8.81132208419E-04 7.36664204523E-04 6.13909284122E-04 5.09946948738E-04 4.22193721765E-04 3.48372692992E-04 2.86484633719E-04 2.34780759663E-04 1.91737195123E-04 1.56031167918E-04 1.26518942650E-04 1.02215479130E-04 8.22757845342E-05 6.59779116055E-05 5.27075416033E-05 4.19440794004E-05 3.32481793688E-05 2.62506141829E-05 2.06423943953E-05 1.61660443220E-05 1.26079392602E-05 9.79161008419E-06 7.57192361154E-06 5.83005055895E-06 4.46913718886E-06 3.41060167816E-06 2.59098161810E-06 1.95926470771E-06 1.47464047836E-06 1.10461665182E-06 8.23449380446E-07 6.10842057570E-07 4.50872532431E-07 3.31113349019E-07 2.41914743792E-07 1.75822603467E-07 1.27109223158E-07 9.13970026243E-08 6.53583646394E-08 4.64778245914E-08 3.28644296294E-08 2.31047689362E-08 1.61484609872E-08 1.12194765550E-08 7.74788512340E-09 5.31764375025E-09 3.62690638670E-09 2.45804157070E-09 1.65512868312E-09 1.10717691389E-09 7.35693959537E-10 4.85538423890E-10 3.18234106196E-10 2.07117177777E-10 1.33838319315E-10 8.58593425144E-11 5.46744251958E-11 3.45554378537E-11 2.16735006461E-11 1.34885802698E-11 8.32858058218E-12 5.10135321152E-12 3.09920661964E-12 1.86726722673E-12 1.11555831010E-12 6.60763347824E-13 3.87975622916E-13 2.25789449608E-13 1.30220201372E-13 7.44153089396E-14 4.21296645589E-14 2.36258225723E-14 1.31216781562E-14 7.21646382166E-15 3.92934376007E-15 2.11788728074E-15 1.12979165195E-15 5.96390618798E-16 3.11474944886E-16 1.60915144368E-16 8.22190528667E-17 4.15402092885E-17 2.07492831477E-17 1.02445237155E-17 4.99860821908E-18 2.40983612076E-18 1.14766947249E-18 5.39812399716E-19 2.50705671337E-19 1.14938295599E-19 5.19992494947E-20 2.32028758190E-20 1.02026197495E-20 4.41282786246E-21 1.86973827283E-21 7.68475558963E-22 2.98773388045E-22 1.02391664925E-22 2.41815022469E-23 4.55382476181E-25 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 TDDFPT/Examples/pseudo/H.pz-vbc.UPF0000644000175000017500000003313312341371476015156 0ustar mbamba Generated using ld1 code Author: P. Giannozzi Generation date: 1990 Info: H LDA 1s1 VonBarth-Car local 0 The Pseudo was generated with a Non-Relativistic Calculation 0.00000000000E+00 Local Potential cutoff radius nl pn l occ Rcut Rcut US E pseu 1S 0 0 1.00 0.00000000000 0.00000000000 0.00000000000 0 Version Number H Element NC Norm - Conserving pseudopotential F Nonlinear Core Correction SLA PZ NOGX NOGC PZ Exchange-Correlation functional 1.00000000000 Z valence 0.00000000000 Total energy 0.0000000 0.0000000 Suggested cutoff for wfc and rho -1 Max angular momentum component 131 Number of points in mesh 1 0 Number of Wavefunctions, Number of Projectors Wavefunctions nl l occ 1S 0 1.00 1.83156388887E-02 1.94968961086E-02 2.07543378737E-02 2.20928776651E-02 2.35177458560E-02 2.50345101500E-02 2.66490973364E-02 2.83678164497E-02 3.01973834223E-02 3.21449473269E-02 3.42181183117E-02 3.64249973374E-02 3.87742078317E-02 4.12749293858E-02 4.39369336234E-02 4.67706223840E-02 4.97870683679E-02 5.29980584034E-02 5.64161395038E-02 6.00546678953E-02 6.39278612067E-02 6.80508540250E-02 7.24397570343E-02 7.71117199683E-02 8.20849986239E-02 8.73790261954E-02 9.30144892107E-02 9.90134083638E-02 1.05399224562E-01 1.12196890520E-01 1.19432968267E-01 1.27135732932E-01 1.35335283237E-01 1.44063659101E-01 1.53354966845E-01 1.63245512454E-01 1.73773943450E-01 1.84981399907E-01 1.96911675204E-01 2.09611387151E-01 2.23130160148E-01 2.37520819095E-01 2.52839595805E-01 2.69146348729E-01 2.86504796860E-01 3.04982768711E-01 3.24652467358E-01 3.45590752577E-01 3.67879441171E-01 3.91605626677E-01 4.16862019679E-01 4.43747310081E-01 4.72366552741E-01 5.02831577971E-01 5.35261428519E-01 5.69782824731E-01 6.06530659713E-01 6.45648526428E-01 6.87289278791E-01 7.31615628947E-01 7.78800783071E-01 8.29029118180E-01 8.82496902585E-01 9.39413062813E-01 1.00000000000E+00 1.06449445892E+00 1.13314845307E+00 1.20623024942E+00 1.28402541669E+00 1.36683794117E+00 1.45499141462E+00 1.54883029863E+00 1.64872127070E+00 1.75505465696E+00 1.86824595743E+00 1.98873746958E+00 2.11700001661E+00 2.25353478721E+00 2.39887529397E+00 2.55358945806E+00 2.71828182846E+00 2.89359594417E+00 3.08021684892E+00 3.27887376794E+00 3.49034295746E+00 3.71545073794E+00 3.95507672292E+00 4.21015725614E+00 4.48168907034E+00 4.77073318197E+00 5.07841903718E+00 5.40594892514E+00 5.75460267601E+00 6.12574266188E+00 6.52081912033E+00 6.94137582120E+00 7.38905609893E+00 7.86560927394E+00 8.37289748813E+00 8.91290298120E+00 9.48773583636E+00 1.00996422255E+01 1.07510131861E+01 1.14443939643E+01 1.21824939607E+01 1.29681973170E+01 1.38045741861E+01 1.46948927288E+01 1.56426318842E+01 1.66514949636E+01 1.77254241215E+01 1.88686157593E+01 2.00855369232E+01 2.13809427591E+01 2.27598950935E+01 2.42277822126E+01 2.57903399172E+01 2.74536739355E+01 2.92242837812E+01 3.11090881510E+01 3.31154519587E+01 3.52512151146E+01 3.75247231596E+01 3.99448598758E+01 4.25210820001E+01 4.52634561763E+01 4.81826982911E+01 5.12902153466E+01 5.45981500331E+01 5.81194281774E+01 6.18678092504E+01 1.14472743055E-03 1.21855600679E-03 1.29714611711E-03 1.38080485407E-03 1.46985911600E-03 1.56465688437E-03 1.66556858352E-03 1.77298852811E-03 1.88733646389E-03 2.00905920793E-03 2.13863239448E-03 2.27656233359E-03 2.42338798948E-03 2.57968308661E-03 2.74605835146E-03 2.92316389900E-03 3.11169177299E-03 3.31237865021E-03 3.52600871899E-03 3.75341674346E-03 3.99549132542E-03 4.25317837656E-03 4.52748481464E-03 4.81948249802E-03 5.13031241399E-03 5.46118913721E-03 5.81340557567E-03 6.18833802274E-03 6.58745153512E-03 7.01230565752E-03 7.46456051667E-03 7.94598330825E-03 8.45845520229E-03 9.00397869384E-03 9.58468542781E-03 1.02028445284E-02 1.08608714657E-02 1.15613374942E-02 1.23069797003E-02 1.31007116969E-02 1.39456350093E-02 1.48450511935E-02 1.58024747378E-02 1.68216467956E-02 1.79065498038E-02 1.90614230444E-02 2.02907792099E-02 2.15994220361E-02 2.29924650732E-02 2.44753516673E-02 2.60538762299E-02 2.77342068801E-02 2.95229095463E-02 3.14269736232E-02 3.34538392824E-02 3.56114265457E-02 3.79081662320E-02 4.03530329017E-02 4.29555799244E-02 4.57259768092E-02 4.86750489420E-02 5.18143198863E-02 5.51560564115E-02 5.87133164258E-02 6.25000000000E-02 6.65309036824E-02 7.08217783167E-02 7.53893905888E-02 8.02515885430E-02 8.54273713234E-02 9.09369634136E-02 9.68018936646E-02 1.03045079419E-01 1.09690916060E-01 1.16765372340E-01 1.24296091849E-01 1.32312501038E-01 1.40845924201E-01 1.49929705873E-01 1.59599341129E-01 1.69892614279E-01 1.80849746511E-01 1.92513553057E-01 2.04929610496E-01 2.18146434841E-01 2.32215671121E-01 2.47192295183E-01 2.63134828509E-01 2.80105566896E-01 2.98170823873E-01 3.17401189824E-01 3.37871807821E-01 3.59662667250E-01 3.82858916368E-01 4.07551195021E-01 4.33835988825E-01 4.61816006183E-01 4.91600579622E-01 5.23306093008E-01 5.57056436325E-01 5.92983489772E-01 6.31227639093E-01 6.71938324130E-01 7.15274622771E-01 7.61405872544E-01 8.10512332311E-01 8.62785886629E-01 9.18430795549E-01 9.77664492762E-01 1.04071843523E+00 1.10783900759E+00 1.17928848495E+00 1.25534605770E+00 1.33630892245E+00 1.42249344335E+00 1.51423638829E+00 1.61189624482E+00 1.71585462097E+00 1.82651773633E+00 1.94431800944E+00 2.06971574742E+00 2.20320094466E+00 2.34529519748E+00 2.49655374224E+00 2.65756762500E+00 2.82896601102E+00 3.01141864319E+00 3.20563845916E+00 3.41238437707E+00 3.63246426109E+00 3.86673807815E+00 -1.28520734427E+01 -1.28477738461E+01 -1.28429043374E+01 -1.28373897623E+01 -1.28311451659E+01 -1.28240745458E+01 -1.28160694557E+01 -1.28070074434E+01 -1.27967503082E+01 -1.27851421602E+01 -1.27720072639E+01 -1.27571476510E+01 -1.27403404858E+01 -1.27213351692E+01 -1.26998501721E+01 -1.26755695914E+01 -1.26481394325E+01 -1.26171636282E+01 -1.25821998225E+01 -1.25427549619E+01 -1.24982807663E+01 -1.24481691770E+01 -1.23917479276E+01 -1.23282764256E+01 -1.22569422046E+01 -1.21768582750E+01 -1.20870617994E+01 -1.19865146239E+01 -1.18741063179E+01 -1.17486605129E+01 -1.16089454723E+01 -1.14536899624E+01 -1.12816056190E+01 -1.10914170789E+01 -1.08819011471E+01 -1.06519361513E+01 -1.04005623252E+01 -1.01270535093E+01 -9.83099956200E+00 -9.51239758030E+00 -9.17174826485E+00 -8.81015154043E+00 -8.42939293729E+00 -8.03200948773E+00 -7.62132142072E+00 -7.20141440844E+00 -6.77705742491E+00 -6.35354445007E+00 -5.93645523944E+00 -5.53134165780E+00 -5.14336112886E+00 -4.77689553020E+00 -4.43520848186E+00 -4.12020105875E+00 -3.83231994255E+00 -3.57064956816E+00 -3.33318260449E+00 -3.11721972628E+00 -2.91981450742E+00 -2.73816754273E+00 -2.56989350774E+00 -2.41313003425E+00 -2.26650901749E+00 -2.12904646842E+00 -2.00001310323E+00 -1.87882857167E+00 -1.76499416977E+00 -1.65805827847E+00 -1.55760156978E+00 -1.46323125812E+00 -1.37457855759E+00 -1.29129705286E+00 -1.21306131943E+00 -1.13956564946E+00 -1.07052285704E+00 -1.00566315594E+00 -9.44733105482E-01 -8.87494620162E-01 -8.33724039357E-01 -7.83211253354E-01 -7.35758882343E-01 -6.91181505154E-01 -6.49304934717E-01 -6.09965537422E-01 -5.73009593720E-01 -5.38292697458E-01 -5.05679191609E-01 -4.75041638191E-01 -4.46260320297E-01 -4.19222774302E-01 -3.93823350408E-01 -3.69962799815E-01 -3.47547886901E-01 -3.26491024908E-01 -3.06709933690E-01 -2.88127318203E-01 -2.70670566473E-01 -2.54271465864E-01 -2.38865936533E-01 -2.24393781041E-01 -2.10798449124E-01 -1.98026816728E-01 -1.86028978421E-01 -1.74758052391E-01 -1.64169997248E-01 -1.54223439937E-01 -1.44879514069E-01 -1.36101708050E-01 -1.27855722413E-01 -1.20109335791E-01 -1.12832279008E-01 -1.05996116807E-01 -9.95741367357E-02 -9.35412447679E-02 -8.78738672468E-02 -8.25498587716E-02 -7.75484156634E-02 -7.28499946747E-02 -6.84362366233E-02 -6.42898946538E-02 -6.03947668446E-02 -5.67356328994E-02 -5.32981946727E-02 -5.00690202999E-02 -4.70354917120E-02 -4.41857553301E-02 -4.15086757474E-02 -3.89937922172E-02 -3.66312777775E-02 -3.44119008517E-02 -3.23269891763E-02 0 Number of nonzero Dij 1S 0 1.00 Wavefunction 2.88417980000E-02 3.06992250000E-02 3.26758880000E-02 3.47793630000E-02 3.70176890000E-02 3.93993980000E-02 4.19335360000E-02 4.46296930000E-02 4.74980260000E-02 5.05492900000E-02 5.37948600000E-02 5.72467610000E-02 6.09176880000E-02 6.48210330000E-02 6.89709010000E-02 7.33821290000E-02 7.80702990000E-02 8.30517390000E-02 8.83435240000E-02 9.39634680000E-02 9.99300930000E-02 1.06262600000E-01 1.12980800000E-01 1.20105060000E-01 1.27656180000E-01 1.35655270000E-01 1.44123610000E-01 1.53082380000E-01 1.62552520000E-01 1.72554300000E-01 1.83107100000E-01 1.94228900000E-01 2.05935850000E-01 2.18241720000E-01 2.31157310000E-01 2.44689750000E-01 2.58841850000E-01 2.73611310000E-01 2.88989960000E-01 3.04963070000E-01 3.21508570000E-01 3.38596550000E-01 3.56188710000E-01 3.74238100000E-01 3.92689030000E-01 4.11477200000E-01 4.30530040000E-01 4.49767230000E-01 4.69101320000E-01 4.88438290000E-01 5.07678040000E-01 5.26714510000E-01 5.45435510000E-01 5.63722120000E-01 5.81447800000E-01 5.98477370000E-01 6.14666190000E-01 6.29859740000E-01 6.43894030000E-01 6.56596810000E-01 6.67789700000E-01 6.77290980000E-01 6.84919040000E-01 6.90496050000E-01 6.93851860000E-01 6.94828030000E-01 6.93282060000E-01 6.89091610000E-01 6.82158800000E-01 6.72414560000E-01 6.59822730000E-01 6.44383970000E-01 6.26139280000E-01 6.05172840000E-01 5.81614290000E-01 5.55639920000E-01 5.27472870000E-01 4.97381950000E-01 4.65679080000E-01 4.32715040000E-01 3.98873460000E-01 3.64563110000E-01 3.30208380000E-01 2.96238340000E-01 2.63074440000E-01 2.31117590000E-01 2.00735080000E-01 1.72248160000E-01 1.45921080000E-01 1.21952430000E-01 1.00469460000E-01 8.15259110000E-02 6.51037310000E-02 5.11184740000E-02 3.94280920000E-02 2.98443810000E-02 2.21461340000E-02 1.60929310000E-02 1.14384770000E-02 7.94251530000E-03 5.38057890000E-03 3.55111180000E-03 2.27982720000E-03 1.42143930000E-03 8.59150620000E-04 5.02420710000E-04 2.83624610000E-04 1.54298730000E-04 8.07158740000E-05 4.05091800000E-05 1.94783590000E-05 9.00917540000E-06 4.14767900000E-06 1.81282520000E-06 7.49686700000E-07 2.92297650000E-07 1.07038760000E-07 3.66664760000E-08 1.16987270000E-08 3.46064980000E-09 9.44509430000E-10 2.36607150000E-10 5.41028540000E-11 1.12260320000E-11 2.10050760000E-12 3.52060130000E-13 5.24831520000E-14 6.90637980000E-15 7.95818150000E-16 7.96141140000E-17 6.85203010000E-18 8.31849311873E-04 9.42442415601E-04 1.06771365659E-03 1.20960409069E-03 1.37030929890E-03 1.55231256276E-03 1.75842144146E-03 1.99180949727E-03 2.25606247390E-03 2.55523071950E-03 2.89388696242E-03 3.27719164499E-03 3.71096471127E-03 4.20176631919E-03 4.75698518475E-03 5.38493685657E-03 6.09497158595E-03 6.89759135092E-03 7.80457823274E-03 8.82913331859E-03 9.98602348699E-03 1.12917401588E-02 1.27646611686E-02 1.44252254376E-02 1.62961002922E-02 1.84023522788E-02 2.07716149594E-02 2.34342150665E-02 2.64233217584E-02 2.97749864485E-02 3.35282100704E-02 3.77248655952E-02 4.24095743152E-02 4.76294483486E-02 5.34337019664E-02 5.98730737551E-02 6.69991033114E-02 7.48631489599E-02 8.35151969808E-02 9.30024740638E-02 1.03367760583E-01 1.14647623672E-01 1.26870397131E-01 1.40054155492E-01 1.54204674282E-01 1.69313486120E-01 1.85356115342E-01 2.02290561182E-01 2.20056048426E-01 2.38571963138E-01 2.57736992298E-01 2.77428175045E-01 2.97499895569E-01 3.17782628577E-01 3.38081544125E-01 3.58175162402E-01 3.77814525129E-01 3.96723292073E-01 4.14599521870E-01 4.31119370902E-01 4.45943083426E-01 4.58723071589E-01 4.69114091355E-01 4.76784795066E-01 4.81430403625E-01 4.82785991274E-01 4.80640014718E-01 4.74847246972E-01 4.65340628417E-01 4.52141340500E-01 4.35366035025E-01 4.15230700793E-01 3.92050397959E-01 3.66234166274E-01 3.38275182332E-01 3.08735720698E-01 2.78227628586E-01 2.47388804186E-01 2.16857005550E-01 1.87242305842E-01 1.59100037092E-01 1.32906261173E-01 1.09037574222E-01 8.77571540860E-02 6.92081609813E-02 5.34153404074E-02 4.02945723426E-02 2.96694286234E-02 2.12929615884E-02 1.48723951829E-02 1.00941123927E-02 6.64647416438E-03 4.23849579012E-03 2.61309838409E-03 1.55457443876E-03 8.90687077273E-04 4.90451251146E-04 2.58982428171E-04 1.30838756080E-04 6.30835492907E-05 2.89506292991E-05 1.26103950161E-05 5.19761206186E-06 2.02048968358E-06 7.38139787846E-07 2.52426569837E-07 8.04429193977E-08 2.38080980796E-08 6.51505231558E-09 1.64099366427E-09 3.79406469333E-10 8.11652413880E-11 1.72032410870E-11 3.28633520576E-12 5.62030148157E-13 8.54379161955E-14 1.14572961423E-14 1.34443046226E-15 1.36860213421E-16 1.19760970382E-17 8.92098063359E-19 5.59829434311E-20 2.92711881095E-21 1.26023794465E-22 4.41213217766E-24 1.23946335136E-25 2.75448124386E-27 4.76980819418E-29 6.33326527869E-31 6.33840714800E-33 4.69503164913E-35 TDDFPT/Examples/pseudo/O.pbe-rrkjus.UPF0000644000175000017500000160306712341371476016062 0ustar mbamba Generated using Andrea Dal Corso code (rrkj3) Author: Andrea Dal Corso Generation date: unknown Info: O PBE 2s2 2p4 RRKJ3 US 1 The Pseudo was generated with a Scalar-Relativistic Calculation 1.40000000000E+00 Local Potential cutoff radius nl pn l occ Rcut Rcut US E pseu 2S 1 0 2.00 1.40000000000 1.60000000000 0.00000000000 2S 1 0 0.00 1.40000000000 1.60000000000 0.00000000000 2P 2 1 4.00 1.40000000000 1.60000000000 0.00000000000 2P 2 1 0.00 1.40000000000 1.60000000000 0.00000000000 3D 3 2 -2.00 1.40000000000 1.40000000000 0.00000000000 0 Version Number O Element US Ultrasoft pseudopotential F Nonlinear Core Correction SLA PW PBE PBE PBE Exchange-Correlation functional 6.00000000000 Z valence -31.39526325800 Total energy 0.0000000 0.0000000 Suggested cutoff for wfc and rho 2 Max angular momentum component 1269 Number of points in mesh 2 4 Number of Wavefunctions, Number of Projectors Wavefunctions nl l occ 2S 0 2.00 2P 1 4.00 3.09844022083E-04 3.12958006275E-04 3.16103286529E-04 3.19280177374E-04 3.22488996503E-04 3.25730064801E-04 3.29003706377E-04 3.32310248597E-04 3.35650022119E-04 3.39023360923E-04 3.42430602346E-04 3.45872087114E-04 3.49348159380E-04 3.52859166752E-04 3.56405460335E-04 3.59987394761E-04 3.63605328227E-04 3.67259622528E-04 3.70950643098E-04 3.74678759041E-04 3.78444343172E-04 3.82247772053E-04 3.86089426030E-04 3.89969689271E-04 3.93888949806E-04 3.97847599564E-04 4.01846034413E-04 4.05884654201E-04 4.09963862793E-04 4.14084068112E-04 4.18245682184E-04 4.22449121172E-04 4.26694805424E-04 4.30983159513E-04 4.35314612276E-04 4.39689596864E-04 4.44108550778E-04 4.48571915916E-04 4.53080138621E-04 4.57633669716E-04 4.62232964560E-04 4.66878483086E-04 4.71570689849E-04 4.76310054074E-04 4.81097049701E-04 4.85932155435E-04 4.90815854788E-04 4.95748636136E-04 5.00730992761E-04 5.05763422903E-04 5.10846429808E-04 5.15980521782E-04 5.21166212238E-04 5.26404019750E-04 5.31694468102E-04 5.37038086344E-04 5.42435408842E-04 5.47886975334E-04 5.53393330979E-04 5.58955026419E-04 5.64572617827E-04 5.70246666967E-04 5.75977741249E-04 5.81766413785E-04 5.87613263448E-04 5.93518874926E-04 5.99483838787E-04 6.05508751531E-04 6.11594215655E-04 6.17740839710E-04 6.23949238364E-04 6.30220032461E-04 6.36553849087E-04 6.42951321629E-04 6.49413089838E-04 6.55939799898E-04 6.62532104484E-04 6.69190662832E-04 6.75916140805E-04 6.82709210955E-04 6.89570552595E-04 6.96500851865E-04 7.03500801801E-04 7.10571102402E-04 7.17712460707E-04 7.24925590855E-04 7.32211214167E-04 7.39570059210E-04 7.47002861876E-04 7.54510365450E-04 7.62093320689E-04 7.69752485896E-04 7.77488626993E-04 7.85302517600E-04 7.93194939114E-04 8.01166680782E-04 8.09218539786E-04 8.17351321319E-04 8.25565838664E-04 8.33862913282E-04 8.42243374886E-04 8.50708061529E-04 8.59257819687E-04 8.67893504343E-04 8.76615979073E-04 8.85426116132E-04 8.94324796539E-04 9.03312910172E-04 9.12391355849E-04 9.21561041421E-04 9.30822883866E-04 9.40177809374E-04 9.49626753447E-04 9.59170660987E-04 9.68810486392E-04 9.78547193653E-04 9.88381756449E-04 9.98315158244E-04 1.00834839239E-03 1.01848246221E-03 1.02871838113E-03 1.03905717274E-03 1.04949987094E-03 1.06004751999E-03 1.07070117469E-03 1.08146190039E-03 1.09233077318E-03 1.10330887997E-03 1.11439731855E-03 1.12559719780E-03 1.13690963771E-03 1.14833576953E-03 1.15987673588E-03 1.17153369088E-03 1.18330780021E-03 1.19520024132E-03 1.20721220344E-03 1.21934488779E-03 1.23159950765E-03 1.24397728848E-03 1.25647946808E-03 1.26910729667E-03 1.28186203705E-03 1.29474496470E-03 1.30775736793E-03 1.32090054798E-03 1.33417581919E-03 1.34758450909E-03 1.36112795857E-03 1.37480752198E-03 1.38862456728E-03 1.40258047620E-03 1.41667664433E-03 1.43091448131E-03 1.44529541093E-03 1.45982087130E-03 1.47449231497E-03 1.48931120910E-03 1.50427903559E-03 1.51939729124E-03 1.53466748788E-03 1.55009115256E-03 1.56566982763E-03 1.58140507100E-03 1.59729845619E-03 1.61335157256E-03 1.62956602543E-03 1.64594343626E-03 1.66248544281E-03 1.67919369928E-03 1.69606987653E-03 1.71311566217E-03 1.73033276081E-03 1.74772289417E-03 1.76528780127E-03 1.78302923862E-03 1.80094898039E-03 1.81904881855E-03 1.83733056311E-03 1.85579604226E-03 1.87444710256E-03 1.89328560913E-03 1.91231344584E-03 1.93153251549E-03 1.95094474000E-03 1.97055206061E-03 1.99035643806E-03 2.01035985282E-03 2.03056430524E-03 2.05097181579E-03 2.07158442522E-03 2.09240419482E-03 2.11343320659E-03 2.13467356344E-03 2.15612738942E-03 2.17779682994E-03 2.19968405195E-03 2.22179124421E-03 2.24412061744E-03 2.26667440460E-03 2.28945486109E-03 2.31246426498E-03 2.33570491722E-03 2.35917914189E-03 2.38288928645E-03 2.40683772192E-03 2.43102684317E-03 2.45545906913E-03 2.48013684305E-03 2.50506263271E-03 2.53023893073E-03 2.55566825474E-03 2.58135314771E-03 2.60729617815E-03 2.63349994038E-03 2.65996705480E-03 2.68670016814E-03 2.71370195373E-03 2.74097511178E-03 2.76852236963E-03 2.79634648202E-03 2.82445023139E-03 2.85283642814E-03 2.88150791090E-03 2.91046754686E-03 2.93971823200E-03 2.96926289141E-03 2.99910447959E-03 3.02924598071E-03 3.05969040896E-03 3.09044080879E-03 3.12150025528E-03 3.15287185440E-03 3.18455874334E-03 3.21656409079E-03 3.24889109734E-03 3.28154299571E-03 3.31452305111E-03 3.34783456158E-03 3.38148085829E-03 3.41546530591E-03 3.44979130291E-03 3.48446228191E-03 3.51948171004E-03 3.55485308927E-03 3.59057995678E-03 3.62666588527E-03 3.66311448338E-03 3.69992939599E-03 3.73711430462E-03 3.77467292779E-03 3.81260902140E-03 3.85092637909E-03 3.88962883263E-03 3.92872025230E-03 3.96820454726E-03 4.00808566598E-03 4.04836759661E-03 4.08905436738E-03 4.13015004699E-03 4.17165874504E-03 4.21358461245E-03 4.25593184182E-03 4.29870466793E-03 4.34190736809E-03 4.38554426261E-03 4.42961971520E-03 4.47413813346E-03 4.51910396926E-03 4.56452171922E-03 4.61039592516E-03 4.65673117453E-03 4.70353210090E-03 4.75080338440E-03 4.79854975219E-03 4.84677597897E-03 4.89548688737E-03 4.94468734855E-03 4.99438228258E-03 5.04457665900E-03 5.09527549730E-03 5.14648386738E-03 5.19820689015E-03 5.25044973793E-03 5.30321763506E-03 5.35651585838E-03 5.41034973775E-03 5.46472465659E-03 5.51964605246E-03 5.57511941753E-03 5.63115029919E-03 5.68774430058E-03 5.74490708113E-03 5.80264435718E-03 5.86096190250E-03 5.91986554889E-03 5.97936118677E-03 6.03945476576E-03 6.10015229525E-03 6.16145984506E-03 6.22338354598E-03 6.28592959045E-03 6.34910423311E-03 6.41291379149E-03 6.47736464659E-03 6.54246324355E-03 6.60821609229E-03 6.67462976815E-03 6.74171091254E-03 6.80946623365E-03 6.87790250705E-03 6.94702657644E-03 7.01684535427E-03 7.08736582248E-03 7.15859503318E-03 7.23054010935E-03 7.30320824556E-03 7.37660670868E-03 7.45074283862E-03 7.52562404905E-03 7.60125782815E-03 7.67765173938E-03 7.75481342217E-03 7.83275059277E-03 7.91147104496E-03 7.99098265084E-03 8.07129336165E-03 8.15241120852E-03 8.23434430330E-03 8.31710083938E-03 8.40068909247E-03 8.48511742147E-03 8.57039426928E-03 8.65652816367E-03 8.74352771808E-03 8.83140163255E-03 8.92015869455E-03 9.00980777985E-03 9.10035785343E-03 9.19181797038E-03 9.28419727679E-03 9.37750501067E-03 9.47175050286E-03 9.56694317799E-03 9.66309255541E-03 9.76020825014E-03 9.85829997383E-03 9.95737753574E-03 1.00574508437E-02 1.01585299051E-02 1.02606248280E-02 1.03637458219E-02 1.04679031990E-02 1.05731073752E-02 1.06793688709E-02 1.07866983124E-02 1.08951064327E-02 1.10046040728E-02 1.11152021824E-02 1.12269118215E-02 1.13397441612E-02 1.14537104847E-02 1.15688221888E-02 1.16850907848E-02 1.18025278995E-02 1.19211452769E-02 1.20409547788E-02 1.21619683862E-02 1.22841982005E-02 1.24076564450E-02 1.25323554654E-02 1.26583077317E-02 1.27855258394E-02 1.29140225104E-02 1.30438105943E-02 1.31749030702E-02 1.33073130474E-02 1.34410537670E-02 1.35761386031E-02 1.37125810644E-02 1.38503947953E-02 1.39895935772E-02 1.41301913301E-02 1.42722021139E-02 1.44156401298E-02 1.45605197217E-02 1.47068553777E-02 1.48546617316E-02 1.50039535639E-02 1.51547458042E-02 1.53070535316E-02 1.54608919772E-02 1.56162765248E-02 1.57732227131E-02 1.59317462369E-02 1.60918629485E-02 1.62535888598E-02 1.64169401436E-02 1.65819331350E-02 1.67485843336E-02 1.69169104046E-02 1.70869281807E-02 1.72586546639E-02 1.74321070269E-02 1.76073026151E-02 1.77842589483E-02 1.79629937222E-02 1.81435248105E-02 1.83258702663E-02 1.85100483244E-02 1.86960774028E-02 1.88839761045E-02 1.90737632196E-02 1.92654577269E-02 1.94590787960E-02 1.96546457892E-02 1.98521782634E-02 2.00516959719E-02 2.02532188667E-02 2.04567671003E-02 2.06623610277E-02 2.08700212084E-02 2.10797684086E-02 2.12916236032E-02 2.15056079779E-02 2.17217429313E-02 2.19400500771E-02 2.21605512462E-02 2.23832684889E-02 2.26082240771E-02 2.28354405066E-02 2.30649404991E-02 2.32967470049E-02 2.35308832048E-02 2.37673725127E-02 2.40062385776E-02 2.42475052864E-02 2.44911967659E-02 2.47373373855E-02 2.49859517594E-02 2.52370647493E-02 2.54907014668E-02 2.57468872756E-02 2.60056477946E-02 2.62670089001E-02 2.65309967283E-02 2.67976376784E-02 2.70669584145E-02 2.73389858690E-02 2.76137472449E-02 2.78912700186E-02 2.81715819424E-02 2.84547110480E-02 2.87406856483E-02 2.90295343412E-02 2.93212860117E-02 2.96159698353E-02 2.99136152805E-02 3.02142521121E-02 3.05179103942E-02 3.08246204927E-02 3.11344130790E-02 3.14473191325E-02 3.17633699441E-02 3.20825971192E-02 3.24050325807E-02 3.27307085725E-02 3.30596576625E-02 3.33919127457E-02 3.37275070481E-02 3.40664741293E-02 3.44088478862E-02 3.47546625566E-02 3.51039527223E-02 3.54567533125E-02 3.58130996075E-02 3.61730272424E-02 3.65365722101E-02 3.69037708655E-02 3.72746599287E-02 3.76492764890E-02 3.80276580083E-02 3.84098423251E-02 3.87958676582E-02 3.91857726103E-02 3.95795961724E-02 3.99773777270E-02 4.03791570528E-02 4.07849743279E-02 4.11948701344E-02 4.16088854623E-02 4.20270617133E-02 4.24494407056E-02 4.28760646773E-02 4.33069762913E-02 4.37422186389E-02 4.41818352448E-02 4.46258700711E-02 4.50743675216E-02 4.55273724464E-02 4.59849301464E-02 4.64470863778E-02 4.69138873564E-02 4.73853797629E-02 4.78616107469E-02 4.83426279318E-02 4.88284794198E-02 4.93192137965E-02 4.98148801356E-02 5.03155280042E-02 5.08212074676E-02 5.13319690940E-02 5.18478639602E-02 5.23689436560E-02 5.28952602897E-02 5.34268664936E-02 5.39638154286E-02 5.45061607902E-02 5.50539568132E-02 5.56072582779E-02 5.61661205147E-02 5.67305994103E-02 5.73007514132E-02 5.78766335389E-02 5.84583033762E-02 5.90458190926E-02 5.96392394401E-02 6.02386237613E-02 6.08440319950E-02 6.14555246826E-02 6.20731629739E-02 6.26970086333E-02 6.33271240457E-02 6.39635722233E-02 6.46064168115E-02 6.52557220951E-02 6.59115530054E-02 6.65739751259E-02 6.72430546993E-02 6.79188586343E-02 6.86014545118E-02 6.92909105918E-02 6.99872958207E-02 7.06906798374E-02 7.14011329811E-02 7.21187262976E-02 7.28435315467E-02 7.35756212098E-02 7.43150684963E-02 7.50619473515E-02 7.58163324641E-02 7.65782992731E-02 7.73479239758E-02 7.81252835353E-02 7.89104556884E-02 7.97035189527E-02 8.05045526354E-02 8.13136368404E-02 8.21308524769E-02 8.29562812670E-02 8.37900057545E-02 8.46321093123E-02 8.54826761515E-02 8.63417913297E-02 8.72095407589E-02 8.80860112148E-02 8.89712903453E-02 8.98654666790E-02 9.07686296342E-02 9.16808695280E-02 9.26022775852E-02 9.35329459473E-02 9.44729676820E-02 9.54224367921E-02 9.63814482254E-02 9.73500978839E-02 9.83284826333E-02 9.93167003129E-02 1.00314849745E-01 1.01323030746E-01 1.02341344135E-01 1.03369891743E-01 1.04408776426E-01 1.05458102075E-01 1.06517973621E-01 1.07588497053E-01 1.08669779425E-01 1.09761928865E-01 1.10865054590E-01 1.11979266912E-01 1.13104677254E-01 1.14241398159E-01 1.15389543298E-01 1.16549227488E-01 1.17720566698E-01 1.18903678063E-01 1.20098679894E-01 1.21305691694E-01 1.22524834163E-01 1.23756229219E-01 1.25000000000E-01 1.26256270886E-01 1.27525167503E-01 1.28806816744E-01 1.30101346774E-01 1.31408887047E-01 1.32729568318E-01 1.34063522657E-01 1.35410883459E-01 1.36771785463E-01 1.38146364759E-01 1.39534758807E-01 1.40937106447E-01 1.42353547916E-01 1.43784224857E-01 1.45229280341E-01 1.46688858874E-01 1.48163106415E-01 1.49652170390E-01 1.51156199707E-01 1.52675344770E-01 1.54209757495E-01 1.55759591323E-01 1.57325001241E-01 1.58906143790E-01 1.60503177086E-01 1.62116260833E-01 1.63745556342E-01 1.65391226542E-01 1.67053436003E-01 1.68732350947E-01 1.70428139267E-01 1.72140970542E-01 1.73871016058E-01 1.75618448820E-01 1.77383443574E-01 1.79166176820E-01 1.80966826833E-01 1.82785573679E-01 1.84622599235E-01 1.86478087205E-01 1.88352223139E-01 1.90245194452E-01 1.92157190444E-01 1.94088402314E-01 1.96039023186E-01 1.98009248124E-01 1.99999274152E-01 2.02009300274E-01 2.04039527494E-01 2.06090158838E-01 2.08161399368E-01 2.10253456212E-01 2.12366538577E-01 2.14500857773E-01 2.16656627233E-01 2.18834062537E-01 2.21033381429E-01 2.23254803844E-01 2.25498551925E-01 2.27764850049E-01 2.30053924848E-01 2.32366005231E-01 2.34701322408E-01 2.37060109913E-01 2.39442603627E-01 2.41849041800E-01 2.44279665079E-01 2.46734716529E-01 2.49214441655E-01 2.51719088434E-01 2.54248907331E-01 2.56804151330E-01 2.59385075959E-01 2.61991939312E-01 2.64625002077E-01 2.67284527562E-01 2.69970781723E-01 2.72684033187E-01 2.75424553282E-01 2.78192616062E-01 2.80988498335E-01 2.83812479692E-01 2.86664842533E-01 2.89545872098E-01 2.92455856491E-01 2.95395086713E-01 2.98363856691E-01 3.01362463302E-01 3.04391206411E-01 3.07450388895E-01 3.10540316673E-01 3.13661298742E-01 3.16813647202E-01 3.19997677291E-01 3.23213707414E-01 3.26462059178E-01 3.29743057419E-01 3.33057030241E-01 3.36404309044E-01 3.39785228557E-01 3.43200126877E-01 3.46649345496E-01 3.50133229337E-01 3.53652126794E-01 3.57206389758E-01 3.60796373658E-01 3.64422437497E-01 3.68084943883E-01 3.71784259070E-01 3.75520752993E-01 3.79294799304E-01 3.83106775412E-01 3.86957062516E-01 3.90846045648E-01 3.94774113711E-01 3.98741659515E-01 4.02749079816E-01 4.06796775361E-01 4.10885150923E-01 4.15014615342E-01 4.19185581569E-01 4.23398466703E-01 4.27653692036E-01 4.31951683095E-01 4.36292869683E-01 4.40677685921E-01 4.45106570294E-01 4.49579965696E-01 4.54098319469E-01 4.58662083452E-01 4.63271714026E-01 4.67927672158E-01 4.72630423446E-01 4.77380438171E-01 4.82178191337E-01 4.87024162724E-01 4.91918836934E-01 4.96862703437E-01 5.01856256624E-01 5.06899995856E-01 5.11994425509E-01 5.17140055031E-01 5.22337398990E-01 5.27586977125E-01 5.32889314396E-01 5.38244941043E-01 5.43654392633E-01 5.49118210115E-01 5.54636939875E-01 5.60211133792E-01 5.65841349289E-01 5.71528149393E-01 5.77272102787E-01 5.83073783874E-01 5.88933772824E-01 5.94852655642E-01 6.00831024222E-01 6.06869476405E-01 6.12968616041E-01 6.19129053049E-01 6.25351403479E-01 6.31636289570E-01 6.37984339817E-01 6.44396189029E-01 6.50872478397E-01 6.57413855556E-01 6.64020974648E-01 6.70694496390E-01 6.77435088141E-01 6.84243423966E-01 6.91120184703E-01 6.98066058035E-01 7.05081738554E-01 7.12167927834E-01 7.19325334501E-01 7.26554674300E-01 7.33856670173E-01 7.41232052324E-01 7.48681558298E-01 7.56205933052E-01 7.63805929029E-01 7.71482306235E-01 7.79235832316E-01 7.87067282628E-01 7.94977440325E-01 8.02967096429E-01 8.11037049911E-01 8.19188107774E-01 8.27421085130E-01 8.35736805285E-01 8.44136099816E-01 8.52619808661E-01 8.61188780198E-01 8.69843871330E-01 8.78585947574E-01 8.87415883145E-01 8.96334561043E-01 9.05342873145E-01 9.14441720289E-01 9.23632012366E-01 9.32914668415E-01 9.42290616708E-01 9.51760794847E-01 9.61326149860E-01 9.70987638288E-01 9.80746226290E-01 9.90602889731E-01 1.00055861429E+00 1.01061439554E+00 1.02077123907E+00 1.03103016058E+00 1.04139218596E+00 1.05185835143E+00 1.06242970361E+00 1.07310729965E+00 1.08389220731E+00 1.09478550509E+00 1.10578828234E+00 1.11690163934E+00 1.12812668743E+00 1.13946454913E+00 1.15091635824E+00 1.16248325994E+00 1.17416641093E+00 1.18596697954E+00 1.19788614585E+00 1.20992510176E+00 1.22208505119E+00 1.23436721015E+00 1.24677280685E+00 1.25930308188E+00 1.27195928826E+00 1.28474269163E+00 1.29765457034E+00 1.31069621559E+00 1.32386893155E+00 1.33717403551E+00 1.35061285799E+00 1.36418674288E+00 1.37789704758E+00 1.39174514313E+00 1.40573241436E+00 1.41986026000E+00 1.43413009285E+00 1.44854333990E+00 1.46310144250E+00 1.47780585646E+00 1.49265805223E+00 1.50765951506E+00 1.52281174509E+00 1.53811625756E+00 1.55357458295E+00 1.56918826708E+00 1.58495887135E+00 1.60088797283E+00 1.61697716444E+00 1.63322805512E+00 1.64964226996E+00 1.66622145040E+00 1.68296725438E+00 1.69988135648E+00 1.71696544813E+00 1.73422123777E+00 1.75165045097E+00 1.76925483067E+00 1.78703613733E+00 1.80499614910E+00 1.82313666199E+00 1.84145949006E+00 1.85996646561E+00 1.87865943936E+00 1.89754028062E+00 1.91661087749E+00 1.93587313704E+00 1.95532898552E+00 1.97498036853E+00 1.99482925122E+00 2.01487761850E+00 2.03512747522E+00 2.05558084639E+00 2.07623977735E+00 2.09710633402E+00 2.11818260307E+00 2.13947069214E+00 2.16097273007E+00 2.18269086707E+00 2.20462727498E+00 2.22678414745E+00 2.24916370019E+00 2.27176817118E+00 2.29459982088E+00 2.31766093247E+00 2.34095381208E+00 2.36448078903E+00 2.38824421603E+00 2.41224646944E+00 2.43648994950E+00 2.46097708060E+00 2.48571031145E+00 2.51069211540E+00 2.53592499066E+00 2.56141146052E+00 2.58715407367E+00 2.61315540439E+00 2.63941805282E+00 2.66594464525E+00 2.69273783438E+00 2.71980029952E+00 2.74713474697E+00 2.77474391018E+00 2.80263055009E+00 2.83079745540E+00 2.85924744281E+00 2.88798335734E+00 2.91700807262E+00 2.94632449113E+00 2.97593554455E+00 3.00584419401E+00 3.03605343039E+00 3.06656627464E+00 3.09738577807E+00 3.12851502267E+00 3.15995712137E+00 3.19171521842E+00 3.22379248965E+00 3.25619214281E+00 3.28891741791E+00 3.32197158748E+00 3.35535795699E+00 3.38907986508E+00 3.42314068399E+00 3.45754381981E+00 3.49229271290E+00 3.52739083818E+00 3.56284170547E+00 3.59864885991E+00 3.63481588222E+00 3.67134638916E+00 3.70824403380E+00 3.74551250592E+00 3.78315553243E+00 3.82117687763E+00 3.85958034371E+00 3.89836977104E+00 3.93754903859E+00 3.97712206433E+00 4.01709280559E+00 4.05746525948E+00 4.09824346328E+00 4.13943149484E+00 4.18103347299E+00 4.22305355798E+00 4.26549595184E+00 4.30836489886E+00 4.35166468595E+00 4.39539964314E+00 4.43957414395E+00 4.48419260588E+00 4.52925949081E+00 4.57477930546E+00 4.62075660185E+00 4.66719597776E+00 4.71410207715E+00 4.76147959067E+00 4.80933325613E+00 4.85766785892E+00 4.90648823254E+00 4.95579925907E+00 5.00560586966E+00 5.05591304501E+00 5.10672581587E+00 5.15804926358E+00 5.20988852050E+00 5.26224877062E+00 5.31513525001E+00 5.36855324735E+00 5.42250810448E+00 5.47700521695E+00 5.53205003450E+00 5.58764806166E+00 5.64380485829E+00 5.70052604011E+00 5.75781727928E+00 5.81568430497E+00 5.87413290395E+00 5.93316892111E+00 5.99279826010E+00 6.05302688392E+00 6.11386081547E+00 6.17530613819E+00 6.23736899668E+00 6.30005559726E+00 6.36337220865E+00 6.42732516257E+00 6.49192085435E+00 6.55716574364E+00 6.62306635496E+00 6.68962927844E+00 6.75686117042E+00 6.82476875414E+00 6.89335882043E+00 6.96263822835E+00 7.03261390589E+00 7.10329285068E+00 7.17468213068E+00 7.24678888487E+00 7.31962032399E+00 7.39318373124E+00 7.46748646302E+00 7.54253594967E+00 7.61833969620E+00 7.69490528305E+00 7.77224036685E+00 7.85035268115E+00 7.92925003727E+00 8.00894032499E+00 8.08943151343E+00 8.17073165175E+00 8.25284887005E+00 8.33579138012E+00 8.41956747626E+00 8.50418553618E+00 8.58965402173E+00 8.67598147984E+00 8.76317654334E+00 8.85124793178E+00 8.94020445240E+00 9.03005500092E+00 9.12080856245E+00 9.21247421245E+00 9.30506111754E+00 9.39857853650E+00 9.49303582115E+00 9.58844241729E+00 9.68480786566E+00 9.78214180289E+00 9.88045396245E+00 9.97975417564E+00 1.00800523726E+01 1.01813585831E+01 1.02836829380E+01 1.03870356698E+01 1.04914271138E+01 1.05968677092E+01 1.07033680003E+01 1.08109386370E+01 1.09195903767E+01 1.10293340845E+01 1.11401807348E+01 1.12521414126E+01 1.13652273138E+01 1.14794497473E+01 1.15948201353E+01 1.17113500149E+01 1.18290510394E+01 1.19479349788E+01 1.20680137216E+01 1.21892992759E+01 1.23118037702E+01 1.24355394552E+01 1.25605187045E+01 1.26867540162E+01 1.28142580138E+01 1.29430434479E+01 1.30731231971E+01 1.32045102696E+01 1.33372178041E+01 1.34712590714E+01 1.36066474759E+01 1.37433965565E+01 1.38815199882E+01 1.40210315835E+01 1.41619452936E+01 1.43042752100E+01 1.44480355659E+01 1.45932407374E+01 1.47399052451E+01 1.48880437556E+01 1.50376710829E+01 1.51888021898E+01 1.53414521897E+01 1.54956363475E+01 1.56513700818E+01 1.58086689663E+01 1.59675487308E+01 1.61280252634E+01 1.62901146121E+01 1.64538329857E+01 1.66191967564E+01 1.67862224606E+01 1.69549268011E+01 1.71253266483E+01 1.72974390425E+01 1.74712811950E+01 1.76468704902E+01 1.78242244871E+01 1.80033609214E+01 1.81842977067E+01 1.83670529370E+01 1.85516448878E+01 1.87380920186E+01 1.89264129743E+01 1.91166265870E+01 1.93087518782E+01 1.95028080608E+01 1.96988145404E+01 1.98967909179E+01 2.00967569911E+01 2.02987327567E+01 2.05027384125E+01 2.07087943592E+01 2.09169212026E+01 2.11271397556E+01 2.13394710402E+01 2.15539362896E+01 2.17705569506E+01 2.19893546855E+01 2.22103513742E+01 2.24335691165E+01 2.26590302344E+01 2.28867572742E+01 2.31167730088E+01 2.33491004400E+01 2.35837628007E+01 2.38207835573E+01 2.40601864122E+01 2.43019953057E+01 2.45462344190E+01 2.47929281762E+01 2.50421012468E+01 2.52937785485E+01 2.55479852491E+01 2.58047467695E+01 2.60640887861E+01 2.63260372333E+01 2.65906183062E+01 2.68578584630E+01 2.71277844281E+01 2.74004231942E+01 2.76758020255E+01 2.79539484601E+01 2.82348903128E+01 2.85186556780E+01 2.88052729326E+01 2.90947707385E+01 2.93871780457E+01 2.96825240951E+01 2.99808384218E+01 3.02821508572E+01 3.05864915330E+01 3.08938908835E+01 3.12043796487E+01 3.15179888779E+01 3.18347499323E+01 3.21546944882E+01 3.24778545404E+01 3.28042624050E+01 3.31339507233E+01 3.34669524642E+01 3.38033009283E+01 3.41430297506E+01 3.44861729043E+01 3.48327647041E+01 3.51828398094E+01 3.55364332280E+01 3.58935803195E+01 3.62543167990E+01 3.66186787403E+01 3.69867025801E+01 3.73584251209E+01 3.77338835353E+01 3.81131153696E+01 3.84961585472E+01 3.88830513727E+01 3.92738325357E+01 3.96685411147E+01 4.00672165809E+01 4.04698988022E+01 4.08766280470E+01 4.12874449887E+01 4.17023907093E+01 4.21215067038E+01 4.25448348840E+01 4.29724175831E+01 4.34042975598E+01 4.38405180025E+01 4.42811225335E+01 4.47261552136E+01 4.51756605465E+01 4.56296834832E+01 4.60882694262E+01 4.65514642345E+01 4.70193142281E+01 4.74918661923E+01 4.79691673826E+01 4.84512655297E+01 4.89382088437E+01 4.94300460194E+01 4.99268262409E+01 5.04285991866E+01 5.09354150342E+01 5.14473244658E+01 5.19643786727E+01 5.24866293608E+01 5.30141287556E+01 5.35469296074E+01 5.40850851968E+01 5.46286493398E+01 5.51776763932E+01 5.57322212603E+01 5.62923393960E+01 5.68580868124E+01 5.74295200850E+01 5.80066963574E+01 5.85896733478E+01 5.91785093544E+01 5.97732632612E+01 6.03739945441E+01 6.09807632768E+01 6.15936301367E+01 6.22126564109E+01 6.28379040025E+01 6.34694354370E+01 6.41073138679E+01 6.47516030835E+01 6.54023675135E+01 6.60596722347E+01 6.67235829782E+01 6.73941661356E+01 6.80714887657E+01 6.87556186015E+01 6.94466240564E+01 7.01445742316E+01 7.08495389227E+01 7.15615886267E+01 7.22807945492E+01 7.30072286114E+01 7.37409634573E+01 7.44820724610E+01 7.52306297340E+01 7.59867101327E+01 7.67503892657E+01 7.75217435016E+01 7.83008499764E+01 7.90877866015E+01 7.98826320712E+01 8.06854658706E+01 8.14963682839E+01 8.23154204019E+01 8.31427041305E+01 8.39783021989E+01 8.48222981674E+01 8.56747764365E+01 8.65358222546E+01 8.74055217270E+01 8.82839618244E+01 8.91712303916E+01 9.00674161561E+01 9.09726087374E+01 9.18868986552E+01 9.28103773396E+01 9.37431371390E+01 9.46852713302E+01 9.56368741275E+01 9.65980406919E+01 9.75688671409E+01 9.85494505578E+01 9.95398890020E+01 3.09844022083E-06 3.12958006275E-06 3.16103286529E-06 3.19280177374E-06 3.22488996503E-06 3.25730064801E-06 3.29003706377E-06 3.32310248597E-06 3.35650022119E-06 3.39023360923E-06 3.42430602346E-06 3.45872087114E-06 3.49348159380E-06 3.52859166752E-06 3.56405460335E-06 3.59987394761E-06 3.63605328227E-06 3.67259622528E-06 3.70950643098E-06 3.74678759041E-06 3.78444343172E-06 3.82247772053E-06 3.86089426030E-06 3.89969689271E-06 3.93888949806E-06 3.97847599564E-06 4.01846034413E-06 4.05884654201E-06 4.09963862793E-06 4.14084068112E-06 4.18245682184E-06 4.22449121172E-06 4.26694805424E-06 4.30983159513E-06 4.35314612276E-06 4.39689596864E-06 4.44108550778E-06 4.48571915916E-06 4.53080138621E-06 4.57633669716E-06 4.62232964560E-06 4.66878483086E-06 4.71570689849E-06 4.76310054074E-06 4.81097049701E-06 4.85932155435E-06 4.90815854788E-06 4.95748636136E-06 5.00730992761E-06 5.05763422903E-06 5.10846429808E-06 5.15980521782E-06 5.21166212238E-06 5.26404019750E-06 5.31694468102E-06 5.37038086344E-06 5.42435408842E-06 5.47886975334E-06 5.53393330979E-06 5.58955026419E-06 5.64572617827E-06 5.70246666967E-06 5.75977741249E-06 5.81766413785E-06 5.87613263448E-06 5.93518874926E-06 5.99483838787E-06 6.05508751531E-06 6.11594215655E-06 6.17740839710E-06 6.23949238364E-06 6.30220032461E-06 6.36553849087E-06 6.42951321629E-06 6.49413089838E-06 6.55939799898E-06 6.62532104484E-06 6.69190662832E-06 6.75916140805E-06 6.82709210955E-06 6.89570552595E-06 6.96500851865E-06 7.03500801801E-06 7.10571102402E-06 7.17712460707E-06 7.24925590855E-06 7.32211214167E-06 7.39570059210E-06 7.47002861876E-06 7.54510365450E-06 7.62093320689E-06 7.69752485896E-06 7.77488626993E-06 7.85302517600E-06 7.93194939114E-06 8.01166680782E-06 8.09218539786E-06 8.17351321319E-06 8.25565838664E-06 8.33862913282E-06 8.42243374886E-06 8.50708061529E-06 8.59257819687E-06 8.67893504343E-06 8.76615979073E-06 8.85426116132E-06 8.94324796539E-06 9.03312910172E-06 9.12391355849E-06 9.21561041421E-06 9.30822883866E-06 9.40177809374E-06 9.49626753447E-06 9.59170660987E-06 9.68810486392E-06 9.78547193653E-06 9.88381756449E-06 9.98315158244E-06 1.00834839239E-05 1.01848246221E-05 1.02871838113E-05 1.03905717274E-05 1.04949987094E-05 1.06004751999E-05 1.07070117469E-05 1.08146190039E-05 1.09233077318E-05 1.10330887997E-05 1.11439731855E-05 1.12559719780E-05 1.13690963771E-05 1.14833576953E-05 1.15987673588E-05 1.17153369088E-05 1.18330780021E-05 1.19520024132E-05 1.20721220344E-05 1.21934488779E-05 1.23159950765E-05 1.24397728848E-05 1.25647946808E-05 1.26910729667E-05 1.28186203705E-05 1.29474496470E-05 1.30775736793E-05 1.32090054798E-05 1.33417581919E-05 1.34758450909E-05 1.36112795857E-05 1.37480752198E-05 1.38862456728E-05 1.40258047620E-05 1.41667664433E-05 1.43091448131E-05 1.44529541093E-05 1.45982087130E-05 1.47449231497E-05 1.48931120910E-05 1.50427903559E-05 1.51939729124E-05 1.53466748788E-05 1.55009115256E-05 1.56566982763E-05 1.58140507100E-05 1.59729845619E-05 1.61335157256E-05 1.62956602543E-05 1.64594343626E-05 1.66248544281E-05 1.67919369928E-05 1.69606987653E-05 1.71311566217E-05 1.73033276081E-05 1.74772289417E-05 1.76528780127E-05 1.78302923862E-05 1.80094898039E-05 1.81904881855E-05 1.83733056311E-05 1.85579604226E-05 1.87444710256E-05 1.89328560913E-05 1.91231344584E-05 1.93153251549E-05 1.95094474000E-05 1.97055206061E-05 1.99035643806E-05 2.01035985282E-05 2.03056430524E-05 2.05097181579E-05 2.07158442522E-05 2.09240419482E-05 2.11343320659E-05 2.13467356344E-05 2.15612738942E-05 2.17779682994E-05 2.19968405195E-05 2.22179124421E-05 2.24412061744E-05 2.26667440460E-05 2.28945486109E-05 2.31246426498E-05 2.33570491722E-05 2.35917914189E-05 2.38288928645E-05 2.40683772192E-05 2.43102684317E-05 2.45545906913E-05 2.48013684305E-05 2.50506263271E-05 2.53023893073E-05 2.55566825474E-05 2.58135314771E-05 2.60729617815E-05 2.63349994038E-05 2.65996705480E-05 2.68670016814E-05 2.71370195373E-05 2.74097511178E-05 2.76852236963E-05 2.79634648202E-05 2.82445023139E-05 2.85283642814E-05 2.88150791090E-05 2.91046754686E-05 2.93971823200E-05 2.96926289141E-05 2.99910447959E-05 3.02924598071E-05 3.05969040896E-05 3.09044080879E-05 3.12150025528E-05 3.15287185440E-05 3.18455874334E-05 3.21656409079E-05 3.24889109734E-05 3.28154299571E-05 3.31452305111E-05 3.34783456158E-05 3.38148085829E-05 3.41546530591E-05 3.44979130291E-05 3.48446228191E-05 3.51948171004E-05 3.55485308927E-05 3.59057995678E-05 3.62666588527E-05 3.66311448338E-05 3.69992939599E-05 3.73711430462E-05 3.77467292779E-05 3.81260902140E-05 3.85092637909E-05 3.88962883263E-05 3.92872025230E-05 3.96820454726E-05 4.00808566598E-05 4.04836759661E-05 4.08905436738E-05 4.13015004699E-05 4.17165874504E-05 4.21358461245E-05 4.25593184182E-05 4.29870466793E-05 4.34190736809E-05 4.38554426261E-05 4.42961971520E-05 4.47413813346E-05 4.51910396926E-05 4.56452171922E-05 4.61039592516E-05 4.65673117453E-05 4.70353210090E-05 4.75080338440E-05 4.79854975219E-05 4.84677597897E-05 4.89548688737E-05 4.94468734855E-05 4.99438228258E-05 5.04457665900E-05 5.09527549730E-05 5.14648386738E-05 5.19820689015E-05 5.25044973793E-05 5.30321763506E-05 5.35651585838E-05 5.41034973775E-05 5.46472465659E-05 5.51964605246E-05 5.57511941753E-05 5.63115029919E-05 5.68774430058E-05 5.74490708113E-05 5.80264435718E-05 5.86096190250E-05 5.91986554889E-05 5.97936118677E-05 6.03945476576E-05 6.10015229525E-05 6.16145984506E-05 6.22338354598E-05 6.28592959045E-05 6.34910423311E-05 6.41291379149E-05 6.47736464659E-05 6.54246324355E-05 6.60821609229E-05 6.67462976815E-05 6.74171091254E-05 6.80946623365E-05 6.87790250705E-05 6.94702657644E-05 7.01684535427E-05 7.08736582248E-05 7.15859503318E-05 7.23054010935E-05 7.30320824556E-05 7.37660670868E-05 7.45074283862E-05 7.52562404905E-05 7.60125782815E-05 7.67765173938E-05 7.75481342217E-05 7.83275059277E-05 7.91147104496E-05 7.99098265084E-05 8.07129336165E-05 8.15241120852E-05 8.23434430330E-05 8.31710083938E-05 8.40068909247E-05 8.48511742147E-05 8.57039426928E-05 8.65652816367E-05 8.74352771808E-05 8.83140163255E-05 8.92015869455E-05 9.00980777985E-05 9.10035785343E-05 9.19181797038E-05 9.28419727679E-05 9.37750501067E-05 9.47175050286E-05 9.56694317799E-05 9.66309255541E-05 9.76020825014E-05 9.85829997383E-05 9.95737753574E-05 1.00574508437E-04 1.01585299051E-04 1.02606248280E-04 1.03637458219E-04 1.04679031990E-04 1.05731073752E-04 1.06793688709E-04 1.07866983124E-04 1.08951064327E-04 1.10046040728E-04 1.11152021824E-04 1.12269118215E-04 1.13397441612E-04 1.14537104847E-04 1.15688221888E-04 1.16850907848E-04 1.18025278995E-04 1.19211452769E-04 1.20409547788E-04 1.21619683862E-04 1.22841982005E-04 1.24076564450E-04 1.25323554654E-04 1.26583077317E-04 1.27855258394E-04 1.29140225104E-04 1.30438105943E-04 1.31749030702E-04 1.33073130474E-04 1.34410537670E-04 1.35761386031E-04 1.37125810644E-04 1.38503947953E-04 1.39895935772E-04 1.41301913301E-04 1.42722021139E-04 1.44156401298E-04 1.45605197217E-04 1.47068553777E-04 1.48546617316E-04 1.50039535639E-04 1.51547458042E-04 1.53070535316E-04 1.54608919772E-04 1.56162765248E-04 1.57732227131E-04 1.59317462369E-04 1.60918629485E-04 1.62535888598E-04 1.64169401436E-04 1.65819331350E-04 1.67485843336E-04 1.69169104046E-04 1.70869281807E-04 1.72586546639E-04 1.74321070269E-04 1.76073026151E-04 1.77842589483E-04 1.79629937222E-04 1.81435248105E-04 1.83258702663E-04 1.85100483244E-04 1.86960774028E-04 1.88839761045E-04 1.90737632196E-04 1.92654577269E-04 1.94590787960E-04 1.96546457892E-04 1.98521782634E-04 2.00516959719E-04 2.02532188667E-04 2.04567671003E-04 2.06623610277E-04 2.08700212084E-04 2.10797684086E-04 2.12916236032E-04 2.15056079779E-04 2.17217429313E-04 2.19400500771E-04 2.21605512462E-04 2.23832684889E-04 2.26082240771E-04 2.28354405066E-04 2.30649404991E-04 2.32967470049E-04 2.35308832048E-04 2.37673725127E-04 2.40062385776E-04 2.42475052864E-04 2.44911967659E-04 2.47373373855E-04 2.49859517594E-04 2.52370647493E-04 2.54907014668E-04 2.57468872756E-04 2.60056477946E-04 2.62670089001E-04 2.65309967283E-04 2.67976376784E-04 2.70669584145E-04 2.73389858690E-04 2.76137472449E-04 2.78912700186E-04 2.81715819424E-04 2.84547110480E-04 2.87406856483E-04 2.90295343412E-04 2.93212860117E-04 2.96159698353E-04 2.99136152805E-04 3.02142521121E-04 3.05179103942E-04 3.08246204927E-04 3.11344130790E-04 3.14473191325E-04 3.17633699441E-04 3.20825971192E-04 3.24050325807E-04 3.27307085725E-04 3.30596576625E-04 3.33919127457E-04 3.37275070481E-04 3.40664741293E-04 3.44088478862E-04 3.47546625566E-04 3.51039527223E-04 3.54567533125E-04 3.58130996075E-04 3.61730272424E-04 3.65365722101E-04 3.69037708655E-04 3.72746599287E-04 3.76492764890E-04 3.80276580083E-04 3.84098423251E-04 3.87958676582E-04 3.91857726103E-04 3.95795961724E-04 3.99773777270E-04 4.03791570528E-04 4.07849743279E-04 4.11948701344E-04 4.16088854623E-04 4.20270617133E-04 4.24494407056E-04 4.28760646773E-04 4.33069762913E-04 4.37422186389E-04 4.41818352448E-04 4.46258700711E-04 4.50743675216E-04 4.55273724464E-04 4.59849301464E-04 4.64470863778E-04 4.69138873564E-04 4.73853797629E-04 4.78616107469E-04 4.83426279318E-04 4.88284794198E-04 4.93192137965E-04 4.98148801356E-04 5.03155280042E-04 5.08212074676E-04 5.13319690940E-04 5.18478639602E-04 5.23689436560E-04 5.28952602897E-04 5.34268664936E-04 5.39638154286E-04 5.45061607902E-04 5.50539568132E-04 5.56072582779E-04 5.61661205147E-04 5.67305994103E-04 5.73007514132E-04 5.78766335389E-04 5.84583033762E-04 5.90458190926E-04 5.96392394401E-04 6.02386237613E-04 6.08440319950E-04 6.14555246826E-04 6.20731629739E-04 6.26970086333E-04 6.33271240457E-04 6.39635722233E-04 6.46064168115E-04 6.52557220951E-04 6.59115530054E-04 6.65739751259E-04 6.72430546993E-04 6.79188586343E-04 6.86014545118E-04 6.92909105918E-04 6.99872958207E-04 7.06906798374E-04 7.14011329811E-04 7.21187262976E-04 7.28435315467E-04 7.35756212098E-04 7.43150684963E-04 7.50619473515E-04 7.58163324641E-04 7.65782992731E-04 7.73479239758E-04 7.81252835353E-04 7.89104556884E-04 7.97035189527E-04 8.05045526354E-04 8.13136368404E-04 8.21308524769E-04 8.29562812670E-04 8.37900057545E-04 8.46321093123E-04 8.54826761515E-04 8.63417913297E-04 8.72095407589E-04 8.80860112148E-04 8.89712903453E-04 8.98654666790E-04 9.07686296342E-04 9.16808695280E-04 9.26022775852E-04 9.35329459473E-04 9.44729676820E-04 9.54224367921E-04 9.63814482254E-04 9.73500978839E-04 9.83284826333E-04 9.93167003129E-04 1.00314849745E-03 1.01323030746E-03 1.02341344135E-03 1.03369891743E-03 1.04408776426E-03 1.05458102075E-03 1.06517973621E-03 1.07588497053E-03 1.08669779425E-03 1.09761928865E-03 1.10865054590E-03 1.11979266912E-03 1.13104677254E-03 1.14241398159E-03 1.15389543298E-03 1.16549227488E-03 1.17720566698E-03 1.18903678063E-03 1.20098679894E-03 1.21305691694E-03 1.22524834163E-03 1.23756229219E-03 1.25000000000E-03 1.26256270886E-03 1.27525167503E-03 1.28806816744E-03 1.30101346774E-03 1.31408887047E-03 1.32729568318E-03 1.34063522657E-03 1.35410883459E-03 1.36771785463E-03 1.38146364759E-03 1.39534758807E-03 1.40937106447E-03 1.42353547916E-03 1.43784224857E-03 1.45229280341E-03 1.46688858874E-03 1.48163106415E-03 1.49652170390E-03 1.51156199707E-03 1.52675344770E-03 1.54209757495E-03 1.55759591323E-03 1.57325001241E-03 1.58906143790E-03 1.60503177086E-03 1.62116260833E-03 1.63745556342E-03 1.65391226542E-03 1.67053436003E-03 1.68732350947E-03 1.70428139267E-03 1.72140970542E-03 1.73871016058E-03 1.75618448820E-03 1.77383443574E-03 1.79166176820E-03 1.80966826833E-03 1.82785573679E-03 1.84622599235E-03 1.86478087205E-03 1.88352223139E-03 1.90245194452E-03 1.92157190444E-03 1.94088402314E-03 1.96039023186E-03 1.98009248124E-03 1.99999274152E-03 2.02009300274E-03 2.04039527494E-03 2.06090158838E-03 2.08161399368E-03 2.10253456212E-03 2.12366538577E-03 2.14500857773E-03 2.16656627233E-03 2.18834062537E-03 2.21033381429E-03 2.23254803844E-03 2.25498551925E-03 2.27764850049E-03 2.30053924848E-03 2.32366005231E-03 2.34701322408E-03 2.37060109913E-03 2.39442603627E-03 2.41849041800E-03 2.44279665079E-03 2.46734716529E-03 2.49214441655E-03 2.51719088434E-03 2.54248907331E-03 2.56804151330E-03 2.59385075959E-03 2.61991939312E-03 2.64625002077E-03 2.67284527562E-03 2.69970781723E-03 2.72684033187E-03 2.75424553282E-03 2.78192616062E-03 2.80988498335E-03 2.83812479692E-03 2.86664842533E-03 2.89545872098E-03 2.92455856491E-03 2.95395086713E-03 2.98363856691E-03 3.01362463302E-03 3.04391206411E-03 3.07450388895E-03 3.10540316673E-03 3.13661298742E-03 3.16813647202E-03 3.19997677291E-03 3.23213707414E-03 3.26462059178E-03 3.29743057419E-03 3.33057030241E-03 3.36404309044E-03 3.39785228557E-03 3.43200126877E-03 3.46649345496E-03 3.50133229337E-03 3.53652126794E-03 3.57206389758E-03 3.60796373658E-03 3.64422437497E-03 3.68084943883E-03 3.71784259070E-03 3.75520752993E-03 3.79294799304E-03 3.83106775412E-03 3.86957062516E-03 3.90846045648E-03 3.94774113711E-03 3.98741659515E-03 4.02749079816E-03 4.06796775361E-03 4.10885150923E-03 4.15014615342E-03 4.19185581569E-03 4.23398466703E-03 4.27653692036E-03 4.31951683095E-03 4.36292869683E-03 4.40677685921E-03 4.45106570294E-03 4.49579965696E-03 4.54098319469E-03 4.58662083452E-03 4.63271714026E-03 4.67927672158E-03 4.72630423446E-03 4.77380438171E-03 4.82178191337E-03 4.87024162724E-03 4.91918836934E-03 4.96862703437E-03 5.01856256624E-03 5.06899995856E-03 5.11994425509E-03 5.17140055031E-03 5.22337398990E-03 5.27586977125E-03 5.32889314396E-03 5.38244941043E-03 5.43654392633E-03 5.49118210115E-03 5.54636939875E-03 5.60211133792E-03 5.65841349289E-03 5.71528149393E-03 5.77272102787E-03 5.83073783874E-03 5.88933772824E-03 5.94852655642E-03 6.00831024222E-03 6.06869476405E-03 6.12968616041E-03 6.19129053049E-03 6.25351403479E-03 6.31636289570E-03 6.37984339817E-03 6.44396189029E-03 6.50872478397E-03 6.57413855556E-03 6.64020974648E-03 6.70694496390E-03 6.77435088141E-03 6.84243423966E-03 6.91120184703E-03 6.98066058035E-03 7.05081738554E-03 7.12167927834E-03 7.19325334501E-03 7.26554674300E-03 7.33856670173E-03 7.41232052324E-03 7.48681558298E-03 7.56205933052E-03 7.63805929029E-03 7.71482306235E-03 7.79235832316E-03 7.87067282628E-03 7.94977440325E-03 8.02967096429E-03 8.11037049911E-03 8.19188107774E-03 8.27421085130E-03 8.35736805285E-03 8.44136099816E-03 8.52619808661E-03 8.61188780198E-03 8.69843871330E-03 8.78585947574E-03 8.87415883145E-03 8.96334561043E-03 9.05342873145E-03 9.14441720289E-03 9.23632012366E-03 9.32914668415E-03 9.42290616708E-03 9.51760794847E-03 9.61326149860E-03 9.70987638288E-03 9.80746226290E-03 9.90602889731E-03 1.00055861429E-02 1.01061439554E-02 1.02077123907E-02 1.03103016058E-02 1.04139218596E-02 1.05185835143E-02 1.06242970361E-02 1.07310729965E-02 1.08389220731E-02 1.09478550509E-02 1.10578828234E-02 1.11690163934E-02 1.12812668743E-02 1.13946454913E-02 1.15091635824E-02 1.16248325994E-02 1.17416641093E-02 1.18596697954E-02 1.19788614585E-02 1.20992510176E-02 1.22208505119E-02 1.23436721015E-02 1.24677280685E-02 1.25930308188E-02 1.27195928826E-02 1.28474269163E-02 1.29765457034E-02 1.31069621559E-02 1.32386893155E-02 1.33717403551E-02 1.35061285799E-02 1.36418674288E-02 1.37789704758E-02 1.39174514313E-02 1.40573241436E-02 1.41986026000E-02 1.43413009285E-02 1.44854333990E-02 1.46310144250E-02 1.47780585646E-02 1.49265805223E-02 1.50765951506E-02 1.52281174509E-02 1.53811625756E-02 1.55357458295E-02 1.56918826708E-02 1.58495887135E-02 1.60088797283E-02 1.61697716444E-02 1.63322805512E-02 1.64964226996E-02 1.66622145040E-02 1.68296725438E-02 1.69988135648E-02 1.71696544813E-02 1.73422123777E-02 1.75165045097E-02 1.76925483067E-02 1.78703613733E-02 1.80499614910E-02 1.82313666199E-02 1.84145949006E-02 1.85996646561E-02 1.87865943936E-02 1.89754028062E-02 1.91661087749E-02 1.93587313704E-02 1.95532898552E-02 1.97498036853E-02 1.99482925122E-02 2.01487761850E-02 2.03512747522E-02 2.05558084639E-02 2.07623977735E-02 2.09710633402E-02 2.11818260307E-02 2.13947069214E-02 2.16097273007E-02 2.18269086707E-02 2.20462727498E-02 2.22678414745E-02 2.24916370019E-02 2.27176817118E-02 2.29459982088E-02 2.31766093247E-02 2.34095381208E-02 2.36448078903E-02 2.38824421603E-02 2.41224646944E-02 2.43648994950E-02 2.46097708060E-02 2.48571031145E-02 2.51069211540E-02 2.53592499066E-02 2.56141146052E-02 2.58715407367E-02 2.61315540439E-02 2.63941805282E-02 2.66594464525E-02 2.69273783438E-02 2.71980029952E-02 2.74713474697E-02 2.77474391018E-02 2.80263055009E-02 2.83079745540E-02 2.85924744281E-02 2.88798335734E-02 2.91700807262E-02 2.94632449113E-02 2.97593554455E-02 3.00584419401E-02 3.03605343039E-02 3.06656627464E-02 3.09738577807E-02 3.12851502267E-02 3.15995712137E-02 3.19171521842E-02 3.22379248965E-02 3.25619214281E-02 3.28891741791E-02 3.32197158748E-02 3.35535795699E-02 3.38907986508E-02 3.42314068399E-02 3.45754381981E-02 3.49229271290E-02 3.52739083818E-02 3.56284170547E-02 3.59864885991E-02 3.63481588222E-02 3.67134638916E-02 3.70824403380E-02 3.74551250592E-02 3.78315553243E-02 3.82117687763E-02 3.85958034371E-02 3.89836977104E-02 3.93754903859E-02 3.97712206433E-02 4.01709280559E-02 4.05746525948E-02 4.09824346328E-02 4.13943149484E-02 4.18103347299E-02 4.22305355798E-02 4.26549595184E-02 4.30836489886E-02 4.35166468595E-02 4.39539964314E-02 4.43957414395E-02 4.48419260588E-02 4.52925949081E-02 4.57477930546E-02 4.62075660185E-02 4.66719597776E-02 4.71410207715E-02 4.76147959067E-02 4.80933325613E-02 4.85766785892E-02 4.90648823254E-02 4.95579925907E-02 5.00560586966E-02 5.05591304501E-02 5.10672581587E-02 5.15804926358E-02 5.20988852050E-02 5.26224877062E-02 5.31513525001E-02 5.36855324735E-02 5.42250810448E-02 5.47700521695E-02 5.53205003450E-02 5.58764806166E-02 5.64380485829E-02 5.70052604011E-02 5.75781727928E-02 5.81568430497E-02 5.87413290395E-02 5.93316892111E-02 5.99279826010E-02 6.05302688392E-02 6.11386081547E-02 6.17530613819E-02 6.23736899668E-02 6.30005559726E-02 6.36337220865E-02 6.42732516257E-02 6.49192085435E-02 6.55716574364E-02 6.62306635496E-02 6.68962927844E-02 6.75686117042E-02 6.82476875414E-02 6.89335882043E-02 6.96263822835E-02 7.03261390589E-02 7.10329285068E-02 7.17468213068E-02 7.24678888487E-02 7.31962032399E-02 7.39318373124E-02 7.46748646302E-02 7.54253594967E-02 7.61833969620E-02 7.69490528305E-02 7.77224036685E-02 7.85035268115E-02 7.92925003727E-02 8.00894032499E-02 8.08943151343E-02 8.17073165175E-02 8.25284887005E-02 8.33579138012E-02 8.41956747626E-02 8.50418553618E-02 8.58965402173E-02 8.67598147984E-02 8.76317654334E-02 8.85124793178E-02 8.94020445240E-02 9.03005500092E-02 9.12080856245E-02 9.21247421245E-02 9.30506111754E-02 9.39857853650E-02 9.49303582115E-02 9.58844241729E-02 9.68480786566E-02 9.78214180289E-02 9.88045396245E-02 9.97975417564E-02 1.00800523726E-01 1.01813585831E-01 1.02836829380E-01 1.03870356698E-01 1.04914271138E-01 1.05968677092E-01 1.07033680003E-01 1.08109386370E-01 1.09195903767E-01 1.10293340845E-01 1.11401807348E-01 1.12521414126E-01 1.13652273138E-01 1.14794497473E-01 1.15948201353E-01 1.17113500149E-01 1.18290510394E-01 1.19479349788E-01 1.20680137216E-01 1.21892992759E-01 1.23118037702E-01 1.24355394552E-01 1.25605187045E-01 1.26867540162E-01 1.28142580138E-01 1.29430434479E-01 1.30731231971E-01 1.32045102696E-01 1.33372178041E-01 1.34712590714E-01 1.36066474759E-01 1.37433965565E-01 1.38815199882E-01 1.40210315835E-01 1.41619452936E-01 1.43042752100E-01 1.44480355659E-01 1.45932407374E-01 1.47399052451E-01 1.48880437556E-01 1.50376710829E-01 1.51888021898E-01 1.53414521897E-01 1.54956363475E-01 1.56513700818E-01 1.58086689663E-01 1.59675487308E-01 1.61280252634E-01 1.62901146121E-01 1.64538329857E-01 1.66191967564E-01 1.67862224606E-01 1.69549268011E-01 1.71253266483E-01 1.72974390425E-01 1.74712811950E-01 1.76468704902E-01 1.78242244871E-01 1.80033609214E-01 1.81842977067E-01 1.83670529370E-01 1.85516448878E-01 1.87380920186E-01 1.89264129743E-01 1.91166265870E-01 1.93087518782E-01 1.95028080608E-01 1.96988145404E-01 1.98967909179E-01 2.00967569911E-01 2.02987327567E-01 2.05027384125E-01 2.07087943592E-01 2.09169212026E-01 2.11271397556E-01 2.13394710402E-01 2.15539362896E-01 2.17705569506E-01 2.19893546855E-01 2.22103513742E-01 2.24335691165E-01 2.26590302344E-01 2.28867572742E-01 2.31167730088E-01 2.33491004400E-01 2.35837628007E-01 2.38207835573E-01 2.40601864122E-01 2.43019953057E-01 2.45462344190E-01 2.47929281762E-01 2.50421012468E-01 2.52937785485E-01 2.55479852491E-01 2.58047467695E-01 2.60640887861E-01 2.63260372333E-01 2.65906183062E-01 2.68578584630E-01 2.71277844281E-01 2.74004231942E-01 2.76758020255E-01 2.79539484601E-01 2.82348903128E-01 2.85186556780E-01 2.88052729326E-01 2.90947707385E-01 2.93871780457E-01 2.96825240951E-01 2.99808384218E-01 3.02821508572E-01 3.05864915330E-01 3.08938908835E-01 3.12043796487E-01 3.15179888779E-01 3.18347499323E-01 3.21546944882E-01 3.24778545404E-01 3.28042624050E-01 3.31339507233E-01 3.34669524642E-01 3.38033009283E-01 3.41430297506E-01 3.44861729043E-01 3.48327647041E-01 3.51828398094E-01 3.55364332280E-01 3.58935803195E-01 3.62543167990E-01 3.66186787403E-01 3.69867025801E-01 3.73584251209E-01 3.77338835353E-01 3.81131153696E-01 3.84961585472E-01 3.88830513727E-01 3.92738325357E-01 3.96685411147E-01 4.00672165809E-01 4.04698988022E-01 4.08766280470E-01 4.12874449887E-01 4.17023907093E-01 4.21215067038E-01 4.25448348840E-01 4.29724175831E-01 4.34042975598E-01 4.38405180025E-01 4.42811225335E-01 4.47261552136E-01 4.51756605465E-01 4.56296834832E-01 4.60882694262E-01 4.65514642345E-01 4.70193142281E-01 4.74918661923E-01 4.79691673826E-01 4.84512655297E-01 4.89382088437E-01 4.94300460194E-01 4.99268262409E-01 5.04285991866E-01 5.09354150342E-01 5.14473244658E-01 5.19643786727E-01 5.24866293608E-01 5.30141287556E-01 5.35469296074E-01 5.40850851968E-01 5.46286493398E-01 5.51776763932E-01 5.57322212603E-01 5.62923393960E-01 5.68580868124E-01 5.74295200850E-01 5.80066963574E-01 5.85896733478E-01 5.91785093544E-01 5.97732632612E-01 6.03739945441E-01 6.09807632768E-01 6.15936301367E-01 6.22126564109E-01 6.28379040025E-01 6.34694354370E-01 6.41073138679E-01 6.47516030835E-01 6.54023675135E-01 6.60596722347E-01 6.67235829782E-01 6.73941661356E-01 6.80714887657E-01 6.87556186015E-01 6.94466240564E-01 7.01445742316E-01 7.08495389227E-01 7.15615886267E-01 7.22807945492E-01 7.30072286114E-01 7.37409634573E-01 7.44820724610E-01 7.52306297340E-01 7.59867101327E-01 7.67503892657E-01 7.75217435016E-01 7.83008499764E-01 7.90877866015E-01 7.98826320712E-01 8.06854658706E-01 8.14963682839E-01 8.23154204019E-01 8.31427041305E-01 8.39783021989E-01 8.48222981674E-01 8.56747764365E-01 8.65358222546E-01 8.74055217270E-01 8.82839618244E-01 8.91712303916E-01 9.00674161561E-01 9.09726087374E-01 9.18868986552E-01 9.28103773396E-01 9.37431371390E-01 9.46852713302E-01 9.56368741275E-01 9.65980406919E-01 9.75688671409E-01 9.85494505578E-01 9.95398890020E-01 -2.31637536512E+01 -2.31637566967E+01 -2.31637598037E+01 -2.31637629734E+01 -2.31637662075E+01 -2.31637695071E+01 -2.31637728733E+01 -2.31637763070E+01 -2.31637798103E+01 -2.31637833839E+01 -2.31637870299E+01 -2.31637907499E+01 -2.31637945449E+01 -2.31637984164E+01 -2.31638023664E+01 -2.31638063961E+01 -2.31638105069E+01 -2.31638147008E+01 -2.31638189797E+01 -2.31638233447E+01 -2.31638277978E+01 -2.31638323409E+01 -2.31638369760E+01 -2.31638417048E+01 -2.31638465288E+01 -2.31638514502E+01 -2.31638564711E+01 -2.31638615933E+01 -2.31638668193E+01 -2.31638721505E+01 -2.31638775894E+01 -2.31638831387E+01 -2.31638887997E+01 -2.31638945748E+01 -2.31639004663E+01 -2.31639064770E+01 -2.31639126094E+01 -2.31639188660E+01 -2.31639252490E+01 -2.31639317606E+01 -2.31639384030E+01 -2.31639451794E+01 -2.31639520933E+01 -2.31639591471E+01 -2.31639663434E+01 -2.31639736847E+01 -2.31639811740E+01 -2.31639888144E+01 -2.31639966094E+01 -2.31640045619E+01 -2.31640126751E+01 -2.31640209523E+01 -2.31640293968E+01 -2.31640380116E+01 -2.31640468001E+01 -2.31640557663E+01 -2.31640649135E+01 -2.31640742452E+01 -2.31640837656E+01 -2.31640934780E+01 -2.31641033864E+01 -2.31641134957E+01 -2.31641238088E+01 -2.31641343294E+01 -2.31641450627E+01 -2.31641560132E+01 -2.31641671849E+01 -2.31641785820E+01 -2.31641902092E+01 -2.31642020711E+01 -2.31642141724E+01 -2.31642265181E+01 -2.31642391127E+01 -2.31642519617E+01 -2.31642650704E+01 -2.31642784435E+01 -2.31642920869E+01 -2.31643060059E+01 -2.31643202055E+01 -2.31643346918E+01 -2.31643494711E+01 -2.31643645488E+01 -2.31643799305E+01 -2.31643956224E+01 -2.31644116313E+01 -2.31644279638E+01 -2.31644446257E+01 -2.31644616236E+01 -2.31644789650E+01 -2.31644966565E+01 -2.31645147046E+01 -2.31645331172E+01 -2.31645519018E+01 -2.31645710655E+01 -2.31645906159E+01 -2.31646105612E+01 -2.31646309088E+01 -2.31646516669E+01 -2.31646728440E+01 -2.31646944490E+01 -2.31647164900E+01 -2.31647389754E+01 -2.31647619147E+01 -2.31647853171E+01 -2.31648091918E+01 -2.31648335481E+01 -2.31648583958E+01 -2.31648837454E+01 -2.31649096065E+01 -2.31649359888E+01 -2.31649629035E+01 -2.31649903616E+01 -2.31650183739E+01 -2.31650469518E+01 -2.31650761059E+01 -2.31651058476E+01 -2.31651361897E+01 -2.31651671442E+01 -2.31651987229E+01 -2.31652309386E+01 -2.31652638044E+01 -2.31652973332E+01 -2.31653315385E+01 -2.31653664337E+01 -2.31654020325E+01 -2.31654383494E+01 -2.31654753987E+01 -2.31655131948E+01 -2.31655517538E+01 -2.31655910910E+01 -2.31656312210E+01 -2.31656721600E+01 -2.31657139244E+01 -2.31657565311E+01 -2.31657999969E+01 -2.31658443394E+01 -2.31658895766E+01 -2.31659357253E+01 -2.31659828039E+01 -2.31660308319E+01 -2.31660798281E+01 -2.31661298118E+01 -2.31661808031E+01 -2.31662328225E+01 -2.31662858906E+01 -2.31663400277E+01 -2.31663952559E+01 -2.31664515973E+01 -2.31665090739E+01 -2.31665677090E+01 -2.31666275255E+01 -2.31666885468E+01 -2.31667507979E+01 -2.31668143033E+01 -2.31668790880E+01 -2.31669451779E+01 -2.31670125994E+01 -2.31670813783E+01 -2.31671515422E+01 -2.31672231197E+01 -2.31672961386E+01 -2.31673706281E+01 -2.31674466172E+01 -2.31675241358E+01 -2.31676032154E+01 -2.31676838875E+01 -2.31677661837E+01 -2.31678501361E+01 -2.31679357780E+01 -2.31680231439E+01 -2.31681122679E+01 -2.31682031848E+01 -2.31682959312E+01 -2.31683905443E+01 -2.31684870611E+01 -2.31685855190E+01 -2.31686859569E+01 -2.31687884152E+01 -2.31688929336E+01 -2.31689995539E+01 -2.31691083187E+01 -2.31692192702E+01 -2.31693324522E+01 -2.31694479093E+01 -2.31695656872E+01 -2.31696858322E+01 -2.31698083915E+01 -2.31699334133E+01 -2.31700609466E+01 -2.31701910420E+01 -2.31703237511E+01 -2.31704591254E+01 -2.31705972181E+01 -2.31707380839E+01 -2.31708817785E+01 -2.31710283577E+01 -2.31711778783E+01 -2.31713303998E+01 -2.31714859824E+01 -2.31716446862E+01 -2.31718065737E+01 -2.31719717088E+01 -2.31721401556E+01 -2.31723119803E+01 -2.31724872502E+01 -2.31726660337E+01 -2.31728484005E+01 -2.31730344220E+01 -2.31732241712E+01 -2.31734177215E+01 -2.31736151486E+01 -2.31738165300E+01 -2.31740219439E+01 -2.31742314699E+01 -2.31744451898E+01 -2.31746631867E+01 -2.31748855457E+01 -2.31751123530E+01 -2.31753436963E+01 -2.31755796660E+01 -2.31758203535E+01 -2.31760658521E+01 -2.31763162566E+01 -2.31765716642E+01 -2.31768321739E+01 -2.31770978860E+01 -2.31773689033E+01 -2.31776453309E+01 -2.31779272753E+01 -2.31782148448E+01 -2.31785081503E+01 -2.31788073046E+01 -2.31791124232E+01 -2.31794236230E+01 -2.31797410236E+01 -2.31800647470E+01 -2.31803949176E+01 -2.31807316616E+01 -2.31810751074E+01 -2.31814253865E+01 -2.31817826328E+01 -2.31821469829E+01 -2.31825185755E+01 -2.31828975518E+01 -2.31832840567E+01 -2.31836782371E+01 -2.31840802424E+01 -2.31844902251E+01 -2.31849083406E+01 -2.31853347469E+01 -2.31857696056E+01 -2.31862130812E+01 -2.31866653402E+01 -2.31871265536E+01 -2.31875968947E+01 -2.31880765402E+01 -2.31885656703E+01 -2.31890644679E+01 -2.31895731201E+01 -2.31900918169E+01 -2.31906207524E+01 -2.31911601236E+01 -2.31917101308E+01 -2.31922709788E+01 -2.31928428756E+01 -2.31934260329E+01 -2.31940206671E+01 -2.31946269973E+01 -2.31952452473E+01 -2.31958756444E+01 -2.31965184200E+01 -2.31971738104E+01 -2.31978420554E+01 -2.31985233992E+01 -2.31992180911E+01 -2.31999263840E+01 -2.32006485339E+01 -2.32013848031E+01 -2.32021354589E+01 -2.32029007723E+01 -2.32036810190E+01 -2.32044764798E+01 -2.32052874394E+01 -2.32061141883E+01 -2.32069570225E+01 -2.32078162422E+01 -2.32086921530E+01 -2.32095850649E+01 -2.32104952934E+01 -2.32114231598E+01 -2.32123689909E+01 -2.32133331190E+01 -2.32143158815E+01 -2.32153176205E+01 -2.32163386853E+01 -2.32173794302E+01 -2.32184402149E+01 -2.32195214054E+01 -2.32206233729E+01 -2.32217464950E+01 -2.32228911554E+01 -2.32240577443E+01 -2.32252466570E+01 -2.32264582949E+01 -2.32276930666E+01 -2.32289513865E+01 -2.32302336755E+01 -2.32315403601E+01 -2.32328718739E+01 -2.32342286568E+01 -2.32356111550E+01 -2.32370198221E+01 -2.32384551176E+01 -2.32399175070E+01 -2.32414074634E+01 -2.32429254669E+01 -2.32444720037E+01 -2.32460475669E+01 -2.32476526562E+01 -2.32492877779E+01 -2.32509534456E+01 -2.32526501799E+01 -2.32543785075E+01 -2.32561389623E+01 -2.32579320855E+01 -2.32597584251E+01 -2.32616185347E+01 -2.32635129751E+01 -2.32654423156E+01 -2.32674071311E+01 -2.32694080021E+01 -2.32714455170E+01 -2.32735202710E+01 -2.32756328658E+01 -2.32777839092E+01 -2.32799740155E+01 -2.32822038057E+01 -2.32844739074E+01 -2.32867849539E+01 -2.32891375843E+01 -2.32915324445E+01 -2.32939701863E+01 -2.32964514669E+01 -2.32989769497E+01 -2.33015473028E+01 -2.33041631993E+01 -2.33068253189E+01 -2.33095343460E+01 -2.33122909687E+01 -2.33150958806E+01 -2.33179497799E+01 -2.33208533687E+01 -2.33238073522E+01 -2.33268124398E+01 -2.33298693452E+01 -2.33329787847E+01 -2.33361414768E+01 -2.33393581425E+01 -2.33426295051E+01 -2.33459562903E+01 -2.33493392252E+01 -2.33527790369E+01 -2.33562764539E+01 -2.33598322054E+01 -2.33634470200E+01 -2.33671216249E+01 -2.33708567463E+01 -2.33746531099E+01 -2.33785114384E+01 -2.33824324516E+01 -2.33864168662E+01 -2.33904653953E+01 -2.33945787473E+01 -2.33987576257E+01 -2.34030027279E+01 -2.34073147449E+01 -2.34116943605E+01 -2.34161422509E+01 -2.34206590841E+01 -2.34252455179E+01 -2.34299022000E+01 -2.34346297671E+01 -2.34394288440E+01 -2.34443000432E+01 -2.34492439635E+01 -2.34542611886E+01 -2.34593522868E+01 -2.34645178099E+01 -2.34697582916E+01 -2.34750742482E+01 -2.34804661757E+01 -2.34859345493E+01 -2.34914798223E+01 -2.34971024250E+01 -2.35028027641E+01 -2.35085812200E+01 -2.35144381465E+01 -2.35203738708E+01 -2.35263886901E+01 -2.35324828706E+01 -2.35386566484E+01 -2.35449102254E+01 -2.35512437689E+01 -2.35576574115E+01 -2.35641512480E+01 -2.35707253348E+01 -2.35773796878E+01 -2.35841142823E+01 -2.35909290502E+01 -2.35978238788E+01 -2.36047986102E+01 -2.36118530386E+01 -2.36189869093E+01 -2.36261999179E+01 -2.36334917074E+01 -2.36408618680E+01 -2.36483099351E+01 -2.36558353869E+01 -2.36634376444E+01 -2.36711160691E+01 -2.36788699613E+01 -2.36866985593E+01 -2.36946010375E+01 -2.37025765055E+01 -2.37106240054E+01 -2.37187425120E+01 -2.37269309309E+01 -2.37351880960E+01 -2.37435127698E+01 -2.37519036421E+01 -2.37603593270E+01 -2.37688783635E+01 -2.37774592146E+01 -2.37861002648E+01 -2.37947998195E+01 -2.38035561044E+01 -2.38123672656E+01 -2.38212313669E+01 -2.38301463897E+01 -2.38391102326E+01 -2.38481207119E+01 -2.38571755587E+01 -2.38662724201E+01 -2.38754088594E+01 -2.38845823537E+01 -2.38937902960E+01 -2.39030299948E+01 -2.39122986732E+01 -2.39215934695E+01 -2.39309114377E+01 -2.39402495481E+01 -2.39496046879E+01 -2.39589736616E+01 -2.39683531921E+01 -2.39777399210E+01 -2.39871304107E+01 -2.39965211451E+01 -2.40059085306E+01 -2.40152888985E+01 -2.40246585058E+01 -2.40340135374E+01 -2.40433501075E+01 -2.40526642629E+01 -2.40619519841E+01 -2.40712091878E+01 -2.40804317302E+01 -2.40896154085E+01 -2.40987559640E+01 -2.41078490862E+01 -2.41168904150E+01 -2.41258755429E+01 -2.41348000199E+01 -2.41436593567E+01 -2.41524490275E+01 -2.41611644750E+01 -2.41698011133E+01 -2.41783543321E+01 -2.41868195006E+01 -2.41951919723E+01 -2.42034670893E+01 -2.42116401861E+01 -2.42197065945E+01 -2.42276616480E+01 -2.42355006865E+01 -2.42432190615E+01 -2.42508121402E+01 -2.42582753113E+01 -2.42656039887E+01 -2.42727936172E+01 -2.42798396776E+01 -2.42867376914E+01 -2.42934832260E+01 -2.43000718998E+01 -2.43064993867E+01 -2.43127614219E+01 -2.43188538066E+01 -2.43247724123E+01 -2.43305131875E+01 -2.43360721607E+01 -2.43414454461E+01 -2.43466292480E+01 -2.43516198662E+01 -2.43564136998E+01 -2.43610072525E+01 -2.43653971361E+01 -2.43695800750E+01 -2.43735529111E+01 -2.43773126070E+01 -2.43808562502E+01 -2.43841810568E+01 -2.43872843751E+01 -2.43901636888E+01 -2.43928166203E+01 -2.43952409342E+01 -2.43974345398E+01 -2.43993954933E+01 -2.44011220010E+01 -2.44026124211E+01 -2.44038652658E+01 -2.44048792035E+01 -2.44056530599E+01 -2.44061858189E+01 -2.44064766251E+01 -2.44065247835E+01 -2.44063297601E+01 -2.44058911832E+01 -2.44052088423E+01 -2.44042826893E+01 -2.44031128365E+01 -2.44016995575E+01 -2.44000432854E+01 -2.43981446116E+01 -2.43960042845E+01 -2.43936232079E+01 -2.43910024392E+01 -2.43881431865E+01 -2.43850468067E+01 -2.43817148025E+01 -2.43781488195E+01 -2.43743506429E+01 -2.43703221938E+01 -2.43660655257E+01 -2.43615828205E+01 -2.43568763841E+01 -2.43519486418E+01 -2.43468021343E+01 -2.43414395122E+01 -2.43358635309E+01 -2.43300770455E+01 -2.43240830053E+01 -2.43178844482E+01 -2.43114844945E+01 -2.43048863413E+01 -2.42980932563E+01 -2.42911085712E+01 -2.42839356753E+01 -2.42765780095E+01 -2.42690390592E+01 -2.42613223475E+01 -2.42534314285E+01 -2.42453698809E+01 -2.42371413003E+01 -2.42287492927E+01 -2.42201974678E+01 -2.42114894313E+01 -2.42026287788E+01 -2.41936190883E+01 -2.41844639134E+01 -2.41751667768E+01 -2.41657311634E+01 -2.41561605136E+01 -2.41464582169E+01 -2.41366276055E+01 -2.41266719479E+01 -2.41165944430E+01 -2.41063982140E+01 -2.40960863029E+01 -2.40856616648E+01 -2.40751271626E+01 -2.40644855618E+01 -2.40537395259E+01 -2.40428916116E+01 -2.40319442647E+01 -2.40208998157E+01 -2.40097604762E+01 -2.39985283358E+01 -2.39872053581E+01 -2.39757933788E+01 -2.39642941023E+01 -2.39527091002E+01 -2.39410398090E+01 -2.39292875289E+01 -2.39174534220E+01 -2.39055385124E+01 -2.38935436849E+01 -2.38814696852E+01 -2.38693171199E+01 -2.38570864577E+01 -2.38447780292E+01 -2.38323920294E+01 -2.38199285182E+01 -2.38073874231E+01 -2.37947685412E+01 -2.37820715418E+01 -2.37692959694E+01 -2.37564412469E+01 -2.37435066795E+01 -2.37304914579E+01 -2.37173946633E+01 -2.37042152713E+01 -2.36909521569E+01 -2.36776040994E+01 -2.36641697877E+01 -2.36506478261E+01 -2.36370367395E+01 -2.36233349797E+01 -2.36095409318E+01 -2.35956529199E+01 -2.35816692145E+01 -2.35675880382E+01 -2.35534075734E+01 -2.35391259687E+01 -2.35247413460E+01 -2.35102518082E+01 -2.34956554453E+01 -2.34809503428E+01 -2.34661345881E+01 -2.34512062782E+01 -2.34361635267E+01 -2.34210044712E+01 -2.34057272802E+01 -2.33903301602E+01 -2.33748113625E+01 -2.33591691902E+01 -2.33434020044E+01 -2.33275082307E+01 -2.33114863658E+01 -2.32953349825E+01 -2.32790527362E+01 -2.32626383695E+01 -2.32460907178E+01 -2.32294087134E+01 -2.32125913900E+01 -2.31956378867E+01 -2.31785474508E+01 -2.31613194417E+01 -2.31439533322E+01 -2.31264487115E+01 -2.31088052860E+01 -2.30910228807E+01 -2.30731014388E+01 -2.30550410226E+01 -2.30368418114E+01 -2.30185041011E+01 -2.30000283018E+01 -2.29814149349E+01 -2.29626646304E+01 -2.29437781222E+01 -2.29247562442E+01 -2.29055999249E+01 -2.28863101810E+01 -2.28668881116E+01 -2.28473348905E+01 -2.28276517583E+01 -2.28078400140E+01 -2.27879010054E+01 -2.27678361198E+01 -2.27476467723E+01 -2.27273343954E+01 -2.27069004261E+01 -2.26863462935E+01 -2.26656734048E+01 -2.26448831309E+01 -2.26239767909E+01 -2.26029556361E+01 -2.25818208321E+01 -2.25605734414E+01 -2.25392144029E+01 -2.25177445123E+01 -2.24961643993E+01 -2.24744745049E+01 -2.24526750559E+01 -2.24307660387E+01 -2.24087471708E+01 -2.23866178702E+01 -2.23643772230E+01 -2.23420239480E+01 -2.23195563594E+01 -2.22969723264E+01 -2.22742692296E+01 -2.22514439144E+01 -2.22284926409E+01 -2.22054110302E+01 -2.21821940064E+01 -2.21588357351E+01 -2.21353295574E+01 -2.21116679194E+01 -2.20878422974E+01 -2.20638431187E+01 -2.20396596781E+01 -2.20152800499E+01 -2.19906909956E+01 -2.19658778691E+01 -2.19408245175E+01 -2.19155131799E+01 -2.18899243853E+01 -2.18640368485E+01 -2.18378273680E+01 -2.18112707256E+01 -2.17843395894E+01 -2.17570044234E+01 -2.17292334045E+01 -2.17009923501E+01 -2.16722446586E+01 -2.16429512657E+01 -2.16130706189E+01 -2.15825586741E+01 -2.15513689162E+01 -2.15194524070E+01 -2.14867578634E+01 -2.14532317670E+01 -2.14188185087E+01 -2.13834605684E+01 -2.13470987308E+01 -2.13096723372E+01 -2.12711195724E+01 -2.12313777849E+01 -2.11903838363E+01 -2.11480744773E+01 -2.11043867439E+01 -2.10592583681E+01 -2.10126281963E+01 -2.09644366066E+01 -2.09146259187E+01 -2.08631407848E+01 -2.08099285568E+01 -2.07549396173E+01 -2.06981276711E+01 -2.06394499873E+01 -2.05788675876E+01 -2.05163453787E+01 -2.04518522225E+01 -2.03853609480E+01 -2.03168483031E+01 -2.02462948499E+01 -2.01736848093E+01 -2.00990058598E+01 -2.00222488984E+01 -1.99434077711E+01 -1.98624789836E+01 -1.97794613989E+01 -1.96943559329E+01 -1.96071652560E+01 -1.95178935087E+01 -1.94265460383E+01 -1.93331291634E+01 -1.92376499715E+01 -1.91401161526E+01 -1.90405358725E+01 -1.89389176863E+01 -1.88352704941E+01 -1.87296035364E+01 -1.86219264294E+01 -1.85122492363E+01 -1.84005825746E+01 -1.82869377528E+01 -1.81713269358E+01 -1.80537633345E+01 -1.79342614151E+01 -1.78128371258E+01 -1.76895081368E+01 -1.75642940896E+01 -1.74372168537E+01 -1.73083007865E+01 -1.71775729950E+01 -1.70450635950E+01 -1.69108059676E+01 -1.67748370093E+01 -1.66371973748E+01 -1.64979317101E+01 -1.63570888749E+01 -1.62147221525E+01 -1.60708894452E+01 -1.59256534552E+01 -1.57790818480E+01 -1.56312473977E+01 -1.54822281127E+01 -1.53321073401E+01 -1.51809738470E+01 -1.50289218765E+01 -1.48760511779E+01 -1.47224670075E+01 -1.45682800977E+01 -1.44136065936E+01 -1.42585679520E+01 -1.41032908020E+01 -1.39479067629E+01 -1.37925522163E+01 -1.36373680285E+01 -1.34824992207E+01 -1.33280945807E+01 -1.31743062144E+01 -1.30212890306E+01 -1.28692001566E+01 -1.27181982776E+01 -1.25684428983E+01 -1.24200935199E+01 -1.22733087292E+01 -1.21282451963E+01 -1.19850565769E+01 -1.18438923171E+01 -1.17048963591E+01 -1.15682057469E+01 -1.14339491344E+01 -1.13022451989E+01 -1.11732009658E+01 -1.10469100538E+01 -1.09234508547E+01 -1.08028846636E+01 -1.06852537839E+01 -1.05705796364E+01 -1.04588609098E+01 -1.03500717978E+01 -1.02441603807E+01 -1.01410472180E+01 -1.00406242368E+01 -9.94275401110E+00 -9.84726955075E+00 -9.75397473611E+00 -9.66264555950E+00 -9.57303236140E+00 -9.48486328017E+00 -9.39784916902E+00 -9.31169027347E+00 -9.22608500826E+00 -9.14074122368E+00 -9.05539041026E+00 -8.96980535776E+00 -8.88382186076E+00 -8.79736515109E+00 -8.71048183761E+00 -8.62342892143E+00 -8.53687586788E+00 -8.45156505671E+00 -8.36741815789E+00 -8.28416179910E+00 -8.20173372363E+00 -8.12012570376E+00 -8.03932959199E+00 -7.95933732047E+00 -7.88014090026E+00 -7.80173242074E+00 -7.72410404895E+00 -7.64724802905E+00 -7.57115668230E+00 -7.49582240574E+00 -7.42123767034E+00 -7.34739502112E+00 -7.27428707720E+00 -7.20190653086E+00 -7.13024614673E+00 -7.05929876115E+00 -6.98905728143E+00 -6.91949663024E+00 -6.85062813747E+00 -6.78248354297E+00 -6.71501705593E+00 -6.64820197127E+00 -6.58205168743E+00 -6.51655959041E+00 -6.45171913191E+00 -6.38752382872E+00 -6.32396726204E+00 -6.26104307693E+00 -6.19874498160E+00 -6.13706674684E+00 -6.07600220542E+00 -6.01554525143E+00 -5.95568983971E+00 -5.89642998525E+00 -5.83775976259E+00 -5.77967330523E+00 -5.72216480505E+00 -5.66522851172E+00 -5.60885873216E+00 -5.55304982993E+00 -5.49779622468E+00 -5.44309239162E+00 -5.38893286093E+00 -5.33531221724E+00 -5.28222509904E+00 -5.22966619823E+00 -5.17763025948E+00 -5.12611207978E+00 -5.07510650790E+00 -5.02460844385E+00 -4.97461283838E+00 -4.92511469248E+00 -4.87610905685E+00 -4.82759103145E+00 -4.77955576497E+00 -4.73199845433E+00 -4.68491434423E+00 -4.63829872661E+00 -4.59214694038E+00 -4.54645437074E+00 -4.50121644849E+00 -4.45642865015E+00 -4.41208649728E+00 -4.36818555578E+00 -4.32472143566E+00 -4.28168979061E+00 -4.23908631752E+00 -4.19690675604E+00 -4.15514688820E+00 -4.11380253795E+00 -4.07286957076E+00 -4.03234389324E+00 -3.99222145265E+00 -3.95249823661E+00 -3.91317027259E+00 -3.87423362763E+00 -3.83568440784E+00 -3.79751875809E+00 -3.75973286160E+00 -3.72232293958E+00 -3.68528525083E+00 -3.64861609137E+00 -3.61231179412E+00 -3.57636872846E+00 -3.54078329993E+00 -3.50555194987E+00 -3.47067115501E+00 -3.43613742719E+00 -3.40194731297E+00 -3.36809739328E+00 -3.33458428312E+00 -3.30140463118E+00 -3.26855511951E+00 -3.23603246321E+00 -3.20383341008E+00 -3.17195474031E+00 -3.14039326612E+00 -3.10914583149E+00 -3.07820931181E+00 -3.04758061356E+00 -3.01725667404E+00 -2.98723446100E+00 -2.95751097239E+00 -2.92808323602E+00 -2.89894830928E+00 -2.87010327884E+00 -2.84154526037E+00 -2.81327139820E+00 -2.78527886512E+00 -2.75756486199E+00 -2.73012661756E+00 -2.70296138812E+00 -2.67606645726E+00 -2.64943913559E+00 -2.62307676046E+00 -2.59697669572E+00 -2.57113633143E+00 -2.54555308360E+00 -2.52022439396E+00 -2.49514772967E+00 -2.47032058309E+00 -2.44574047152E+00 -2.42140493696E+00 -2.39731154585E+00 -2.37345788883E+00 -2.34984158054E+00 -2.32646025930E+00 -2.30331158697E+00 -2.28039324863E+00 -2.25770295241E+00 -2.23523842924E+00 -2.21299743263E+00 -2.19097773841E+00 -2.16917714457E+00 -2.14759347100E+00 -2.12622455927E+00 -2.10506827243E+00 -2.08412249480E+00 -2.06338513174E+00 -2.04285410946E+00 -2.02252737479E+00 -2.00240289502E+00 -1.98247865763E+00 -1.96275267014E+00 -1.94322295991E+00 -1.92388757390E+00 -1.90474457853E+00 -1.88579205944E+00 -1.86702812135E+00 -1.84845088779E+00 -1.83005850102E+00 -1.81184912173E+00 -1.79382092896E+00 -1.77597211984E+00 -1.75830090945E+00 -1.74080553063E+00 -1.72348423380E+00 -1.70633528682E+00 -1.68935697473E+00 -1.67254759969E+00 -1.65590548073E+00 -1.63942895359E+00 -1.62311637061E+00 -1.60696610050E+00 -1.59097652820E+00 -1.57514605473E+00 -1.55947309703E+00 -1.54395608778E+00 -1.52859347525E+00 -1.51338372317E+00 -1.49832531054E+00 -1.48341673150E+00 -1.46865649517E+00 -1.45404312553E+00 -1.43957516120E+00 -1.42525115540E+00 -1.41106967569E+00 -1.39702930392E+00 -1.38312863604E+00 -1.36936628197E+00 -1.35574086547E+00 -1.34225102398E+00 -1.32889540850E+00 -1.31567268347E+00 -1.30258152103E+00 -1.28962062328E+00 -1.27678868847E+00 -1.26408443340E+00 -1.25150658762E+00 -1.23905389334E+00 -1.22672510530E+00 -1.21451899061E+00 -1.20243432863E+00 -1.19046991092E+00 -1.17862454100E+00 -1.16689703435E+00 -1.15528621820E+00 -1.14379093148E+00 -1.13241002463E+00 -1.12114235957E+00 -1.10998680952E+00 -1.09894225893E+00 -1.08800760333E+00 -1.07718174892E+00 -1.06646361633E+00 -1.05585211348E+00 -1.04534623533E+00 -1.03494490280E+00 -1.02464702895E+00 -1.01445162066E+00 -1.00435765838E+00 -9.94364132705E-01 -9.84470044270E-01 -9.74674403660E-01 -9.64976231303E-01 -9.55374557374E-01 -9.45868421697E-01 -9.36456873651E-01 -9.27138972073E-01 -9.17913785166E-01 -9.08780390402E-01 -8.99737874435E-01 -8.90785333005E-01 -8.81921871956E-01 -8.73146602711E-01 -8.64458648855E-01 -8.55857141583E-01 -8.47341220739E-01 -8.38910034723E-01 -8.30562740409E-01 -8.22298503062E-01 -8.14116496250E-01 -8.06015901766E-01 -7.97995909544E-01 -7.90055717577E-01 -7.82194531840E-01 -7.74411566209E-01 -7.66706042379E-01 -7.59077189792E-01 -7.51524245557E-01 -7.44046454372E-01 -7.36643068453E-01 -7.29313347455E-01 -7.22056558399E-01 -7.14871975600E-01 -7.07758880595E-01 -7.00716562068E-01 -6.93744315781E-01 -6.86841444503E-01 -6.80007257942E-01 -6.73241072674E-01 -6.66542212051E-01 -6.59910006228E-01 -6.53343791955E-01 -6.46842912606E-01 -6.40406718087E-01 -6.34034564773E-01 -6.27725815445E-01 -6.21479839221E-01 -6.15296011499E-01 -6.09173713891E-01 -6.03112334162E-01 -5.97111266169E-01 -5.91169909800E-01 -5.85287670914E-01 -5.79463961284E-01 -5.73698198533E-01 -5.67989806079E-01 -5.62338213080E-01 -5.56742854370E-01 -5.51203170410E-01 -5.45718607226E-01 -5.40288616358E-01 -5.34912654802E-01 -5.29590184956E-01 -5.24320674571E-01 -5.19103596690E-01 -5.13938429602E-01 -5.08824656784E-01 -5.03761766856E-01 -4.98749253525E-01 -4.93786615535E-01 -4.88873356618E-01 -4.84008985444E-01 -4.79193015572E-01 -4.74424965400E-01 -4.69704358121E-01 -4.65030721669E-01 -4.60403588676E-01 -4.55822496426E-01 -4.51286986806E-01 -4.46796606260E-01 -4.42350905747E-01 -4.37949440694E-01 -4.33591770949E-01 -4.29277460743E-01 -4.25006078641E-01 -4.20777197501E-01 -4.16590394431E-01 -4.12445250748E-01 -4.08341351933E-01 -4.04278287594E-01 -4.00255651421E-01 -3.96273041146E-01 -3.92330058506E-01 -3.88426309199E-01 -3.84561402846E-01 -3.80734952954E-01 -3.76946576874E-01 -3.73195895767E-01 -3.69482534560E-01 -3.65806121914E-01 -3.62166290185E-01 -3.58562675387E-01 -3.54994917156E-01 -3.51462658712E-01 -3.47965546827E-01 -3.44503231786E-01 -3.41075367356E-01 -3.37681610746E-01 -3.34321622580E-01 -3.30995066854E-01 -3.27701610910E-01 -3.24440925401E-01 -3.21212684254E-01 -3.18016564644E-01 -3.14852246955E-01 -3.11719414754E-01 -3.08617754753E-01 -3.05546956785E-01 -3.02506713768E-01 -2.99496721674E-01 -2.96516679501E-01 -2.93566289244E-01 -2.90645255861E-01 -2.87753287245E-01 -2.84890094197E-01 -2.82055390397E-01 -2.79248892370E-01 -2.76470319466E-01 -2.73719393824E-01 -2.70995840349E-01 -2.68299386684E-01 -2.65629763182E-01 -2.62986702877E-01 -2.60369941461E-01 -2.57779217257E-01 -2.55214271189E-01 -2.52674846761E-01 -2.50160690029E-01 -2.47671549573E-01 -2.45207176479E-01 -2.42767324308E-01 -2.40351749070E-01 -2.37960209208E-01 -2.35592465566E-01 -2.33248281366E-01 -2.30927422188E-01 -2.28629655946E-01 -2.26354752859E-01 -2.24102485437E-01 -2.21872628449E-01 -2.19664958910E-01 -2.17479256049E-01 -2.15315301295E-01 -2.13172878251E-01 -2.11051772672E-01 -2.08951772446E-01 -2.06872667572E-01 -2.04814250137E-01 -2.02776314298E-01 -2.00758656259E-01 -1.98761074252E-01 -1.96783368519E-01 -1.94825341287E-01 -1.92886796752E-01 -1.90967541056E-01 -1.89067382274E-01 -1.87186130388E-01 -1.85323597271E-01 -1.83479596668E-01 -1.81653944177E-01 -1.79846457232E-01 -1.78056955083E-01 -1.76285258778E-01 -1.74531191146E-01 -1.72794576778E-01 -1.71075242012E-01 -1.69373014912E-01 -1.67687725255E-01 -1.66019204511E-01 -1.64367285825E-01 -1.62731804005E-01 -1.61112595501E-01 -1.59509498390E-01 -1.57922352363E-01 -1.56350998702E-01 -1.54795280272E-01 -1.53255041498E-01 -1.51730128356E-01 -1.50220388354E-01 -1.48725670515E-01 -1.47245825368E-01 -1.45780704926E-01 -1.44330162676E-01 -1.42894053562E-01 -1.41472233973E-01 -1.40064561725E-01 -1.38670896050E-01 -1.37291097580E-01 -1.35925028334E-01 -1.34572551705E-01 -1.33233532442E-01 -1.31907836644E-01 -1.30595331740E-01 -1.29295886478E-01 -1.28009370912E-01 -1.26735656389E-01 -1.25474615538E-01 -1.24226122254E-01 -1.22990051684E-01 -1.21766280223E-01 -1.20554685491E-01 1 0 Beta L 865 2.16793049393E-03 2.18971869524E-03 2.21172587582E-03 2.23395423655E-03 2.25615780539E-03 2.28017635775E-03 2.30280544241E-03 2.32370276269E-03 2.34949657070E-03 2.37141611675E-03 2.39487318092E-03 2.42074342761E-03 2.44390910998E-03 2.46927153632E-03 2.49359017271E-03 2.51930235235E-03 2.54350243449E-03 2.57068480451E-03 2.59446999276E-03 2.62201318958E-03 2.64706627583E-03 2.67583180355E-03 2.70026316635E-03 2.72888991759E-03 2.75497516090E-03 2.78340400493E-03 2.81155922844E-03 2.84099813154E-03 2.86769283464E-03 2.89718293740E-03 2.92587123118E-03 2.95554089014E-03 2.98544817115E-03 3.01515434124E-03 3.04630660080E-03 3.07487705664E-03 3.10796796779E-03 3.13814808628E-03 3.17099515864E-03 3.20148270418E-03 3.23475875427E-03 3.26645114994E-03 3.30024691382E-03 3.33197286994E-03 3.36624507826E-03 3.39977927171E-03 3.43400398184E-03 3.46831137704E-03 3.50314234924E-03 3.53869369166E-03 3.57336341971E-03 3.61026060419E-03 3.64646185096E-03 3.68365541470E-03 3.72060124909E-03 3.75829913346E-03 3.79541804112E-03 3.83322469410E-03 3.87163046003E-03 3.91095785273E-03 3.94983330625E-03 3.99055773588E-03 4.03028714782E-03 4.07025776932E-03 4.11168172855E-03 4.15340072573E-03 4.19458680521E-03 4.23747124906E-03 4.27933152190E-03 4.32256605512E-03 4.36526145439E-03 4.40995885347E-03 4.45477148371E-03 4.49794373071E-03 4.54447804507E-03 4.58973285511E-03 4.63584376717E-03 4.68193269902E-03 4.72950404681E-03 4.77635165298E-03 4.82449317249E-03 4.87387801372E-03 4.92267693763E-03 4.97103628974E-03 5.02172148040E-03 5.07227371661E-03 5.12312999460E-03 5.17542382662E-03 5.22715614444E-03 5.27935428118E-03 5.33219794447E-03 5.38538763865E-03 5.43983469424E-03 5.49410426603E-03 5.55006300605E-03 5.60592347007E-03 5.66166239583E-03 5.71886961415E-03 5.77546989250E-03 5.83498915098E-03 5.89299696758E-03 5.95300362224E-03 6.01180889573E-03 6.07203326791E-03 6.13355103181E-03 6.19514635546E-03 6.25753826914E-03 6.32020132731E-03 6.38415655808E-03 6.44819357078E-03 6.51272256766E-03 6.57878919047E-03 6.64432232500E-03 6.71121382771E-03 6.77897790399E-03 6.84675740211E-03 6.91602367198E-03 6.98490420763E-03 7.05598934784E-03 7.12618917293E-03 7.19763715095E-03 7.27013107128E-03 7.34320711653E-03 7.41702950269E-03 7.49171763117E-03 7.56637304148E-03 7.64373301038E-03 7.71907737180E-03 7.79751631518E-03 7.87584961743E-03 7.95501869140E-03 8.03426050739E-03 8.11560306444E-03 8.19675063967E-03 8.27936392312E-03 8.36220172095E-03 8.44628015023E-03 8.53175144528E-03 8.61705942983E-03 8.70401819153E-03 8.79117507114E-03 8.87931427241E-03 8.96928054752E-03 9.05861353697E-03 9.15046685415E-03 9.24192974406E-03 9.33484028860E-03 9.42919204607E-03 9.52340162409E-03 9.61946656400E-03 9.71571161966E-03 9.81368845020E-03 9.91181746841E-03 1.00117777735E-02 1.01125187192E-02 1.02140901160E-02 1.03167906874E-02 1.04203623738E-02 1.05251533201E-02 1.06311917647E-02 1.07379689304E-02 1.08457485272E-02 1.09549986894E-02 1.10648638098E-02 1.11758164803E-02 1.12881530515E-02 1.14017862118E-02 1.15162731572E-02 1.16321528492E-02 1.17491757682E-02 1.18670618831E-02 1.19863135429E-02 1.21068670009E-02 1.22283943297E-02 1.23514798258E-02 1.24756816125E-02 1.26006948129E-02 1.27277614082E-02 1.28553137303E-02 1.29848842525E-02 1.31150886198E-02 1.32469414042E-02 1.33801705827E-02 1.35147602076E-02 1.36504682616E-02 1.37879403338E-02 1.39260232700E-02 1.40661594448E-02 1.42074969946E-02 1.43499607745E-02 1.44948609342E-02 1.46402219037E-02 1.47872905410E-02 1.49357968674E-02 1.50861773687E-02 1.52379030093E-02 1.53906561833E-02 1.55456442279E-02 1.57016800804E-02 1.58597151475E-02 1.60191603722E-02 1.61797973269E-02 1.63425481963E-02 1.65068544453E-02 1.66726245397E-02 1.68404265635E-02 1.70094226984E-02 1.71804887463E-02 1.73531504993E-02 1.75275512854E-02 1.77036656458E-02 1.78816720316E-02 1.80613414694E-02 1.82428529854E-02 1.84261893371E-02 1.86112955637E-02 1.87985428756E-02 1.89875320192E-02 1.91780683235E-02 1.93710935066E-02 1.95654807063E-02 1.97623293905E-02 1.99610359582E-02 2.01614096397E-02 2.03641343279E-02 2.05687921850E-02 2.07754231679E-02 2.09843156204E-02 2.11951390469E-02 2.14081761846E-02 2.16234155343E-02 2.18407690570E-02 2.20602534763E-02 2.22819209351E-02 2.25058651388E-02 2.27319800525E-02 2.29603431974E-02 2.31914925079E-02 2.34243928454E-02 2.36599004772E-02 2.38975403741E-02 2.41378783926E-02 2.43803655616E-02 2.46254692554E-02 2.48727868962E-02 2.51228884296E-02 2.53753497991E-02 2.56304310181E-02 2.58878878715E-02 2.61482556601E-02 2.64108162664E-02 2.66765993765E-02 2.69443349439E-02 2.72153639199E-02 2.74887491415E-02 2.77650938367E-02 2.80441909463E-02 2.83260314455E-02 2.86105791106E-02 2.88981981426E-02 2.91886436555E-02 2.94820377192E-02 2.97782783236E-02 3.00776070718E-02 3.03799396593E-02 3.06851158485E-02 3.09936422450E-02 3.13051333938E-02 3.16197464312E-02 3.19376654856E-02 3.22586255094E-02 3.25828392437E-02 3.29101911052E-02 3.32409375284E-02 3.35750156606E-02 3.39126376464E-02 3.42534075295E-02 3.45976358810E-02 3.49454027285E-02 3.52966356696E-02 3.56511856990E-02 3.60097934790E-02 3.63714671682E-02 3.67370935307E-02 3.71063351995E-02 3.74791923143E-02 3.78560550474E-02 3.82364892647E-02 3.86206869616E-02 3.90089677557E-02 3.94009445074E-02 3.97968778170E-02 4.01970139308E-02 4.06009515850E-02 4.10090179032E-02 4.14211817986E-02 4.18375296045E-02 4.22579735805E-02 4.26827166061E-02 4.31117354546E-02 4.35450222065E-02 4.39826980049E-02 4.44246667486E-02 4.48713020118E-02 4.53221323574E-02 4.57777832970E-02 4.62378689012E-02 4.67025592905E-02 4.71720094701E-02 4.76460926483E-02 4.81249658302E-02 4.86086248269E-02 4.90972055768E-02 4.95906974828E-02 5.00890258678E-02 5.05925565101E-02 5.11009898950E-02 5.16145757251E-02 5.21334087609E-02 5.26573919265E-02 5.31866371792E-02 5.37212343111E-02 5.42611527543E-02 5.48065159993E-02 5.53573698323E-02 5.59139292053E-02 5.64757548577E-02 5.70434340389E-02 5.76168058327E-02 5.81959333855E-02 5.87808250689E-02 5.93716811842E-02 5.99683815876E-02 6.05711560197E-02 6.11799445082E-02 6.17948905309E-02 6.24159904989E-02 6.30433471278E-02 6.36770445664E-02 6.43170918296E-02 6.49635204229E-02 6.56164724476E-02 6.62760215539E-02 6.69421935890E-02 6.76150930468E-02 6.82947037321E-02 6.89811369997E-02 6.96745097561E-02 7.03748009123E-02 7.10821921757E-02 7.17966656710E-02 7.25184142358E-02 7.32472627664E-02 7.39835485257E-02 7.47271601141E-02 7.54783282751E-02 7.62370534887E-02 7.70032898679E-02 7.77773753977E-02 7.85591524991E-02 7.93488007687E-02 8.01464411319E-02 8.09519857544E-02 8.17658025417E-02 8.25876770270E-02 8.34178840999E-02 8.42563835559E-02 8.51033307832E-02 8.59588683854E-02 8.68228828280E-02 8.76956435695E-02 8.85771934721E-02 8.94675525062E-02 9.03669250331E-02 9.12753741065E-02 9.21928923461E-02 9.31196852824E-02 9.40557084004E-02 9.50012361213E-02 9.59562890782E-02 9.69208617452E-02 9.78952164404E-02 9.88793133910E-02 9.98733523621E-02 1.00877337241E-01 1.01891504829E-01 1.02915765201E-01 1.03950449976E-01 1.04995405773E-01 1.06050984619E-01 1.07117112039E-01 1.08193994407E-01 1.09281727742E-01 1.10380355373E-01 1.11490076014E-01 1.12610959468E-01 1.13743123156E-01 1.14886622596E-01 1.16041697095E-01 1.17208373578E-01 1.18386760208E-01 1.19577022255E-01 1.20779269019E-01 1.21993604241E-01 1.23220176639E-01 1.24459041617E-01 1.25710416682E-01 1.26974369232E-01 1.28251060061E-01 1.29540530813E-01 1.30843114641E-01 1.32158696434E-01 1.33487507911E-01 1.34829747438E-01 1.36185487999E-01 1.37554854268E-01 1.38938029539E-01 1.40335122629E-01 1.41746264010E-01 1.43171638608E-01 1.44611354058E-01 1.46065530912E-01 1.47534364238E-01 1.49018023483E-01 1.50516573337E-01 1.52030205837E-01 1.53559136020E-01 1.55103406135E-01 1.56663277207E-01 1.58238822389E-01 1.59830241230E-01 1.61437678856E-01 1.63061322383E-01 1.64701336921E-01 1.66357810012E-01 1.68031058037E-01 1.69721078487E-01 1.71428177636E-01 1.73152443512E-01 1.74894098841E-01 1.76653311201E-01 1.78430228089E-01 1.80225060845E-01 1.82037978221E-01 1.83869162736E-01 1.85718813603E-01 1.87587079733E-01 1.89474220564E-01 1.91380351994E-01 1.93305708300E-01 1.95250499862E-01 1.97214864901E-01 1.99199056197E-01 2.01203234728E-01 2.03227639087E-01 2.05272471684E-01 2.07337880944E-01 2.09424204927E-01 2.11531490778E-01 2.13660092346E-01 2.15810154161E-01 2.17981888997E-01 2.20175577672E-01 2.22391350397E-01 2.24629524684E-01 2.26890273360E-01 2.29173869417E-01 2.31480486662E-01 2.33810410994E-01 2.36163859167E-01 2.38541070179E-01 2.40942280822E-01 2.43367766154E-01 2.45817718735E-01 2.48292448921E-01 2.50792199752E-01 2.53317172179E-01 2.55867686513E-01 2.58443961550E-01 2.61046287710E-01 2.63674912469E-01 2.66330144697E-01 2.69012204707E-01 2.71721393273E-01 2.74457984784E-01 2.77222269177E-01 2.80014498551E-01 2.82835020242E-01 2.85684071810E-01 2.88561965056E-01 2.91468981393E-01 2.94405463120E-01 2.97371661072E-01 3.00367902209E-01 3.03394510997E-01 3.06451797672E-01 3.09540052291E-01 3.12659611048E-01 3.15810803127E-01 3.18993952183E-01 3.22209385933E-01 3.25457440597E-01 3.28738430764E-01 3.32052748587E-01 3.35400701764E-01 3.38782650122E-01 3.42198934276E-01 3.45649932871E-01 3.49135999155E-01 3.52657479654E-01 3.56214779067E-01 3.59808241188E-01 3.63438260840E-01 3.67105199971E-01 3.70809465459E-01 3.74551435898E-01 3.78331518911E-01 3.82150091687E-01 3.86007568725E-01 3.89904377470E-01 3.93840912105E-01 3.97817598810E-01 4.01834857819E-01 4.05893110834E-01 4.09992803039E-01 4.14134363217E-01 4.18318249525E-01 4.22544900549E-01 4.26814753162E-01 4.31128297935E-01 4.35485991893E-01 4.39888289713E-01 4.44335688347E-01 4.48828646657E-01 4.53367684643E-01 4.57953269878E-01 4.62585928538E-01 4.67266117430E-01 4.71994421189E-01 4.76771295616E-01 4.81597305253E-01 4.86472959612E-01 4.91398821776E-01 4.96375413793E-01 5.01403311114E-01 5.06483047655E-01 5.11615227748E-01 5.16800386852E-01 5.22039123703E-01 5.27332048504E-01 5.32679732087E-01 5.38082802164E-01 5.43541841176E-01 5.49057517754E-01 5.54630430284E-01 5.60261220182E-01 5.65950551288E-01 5.71699073721E-01 5.77507458446E-01 5.83376378337E-01 5.89306517596E-01 5.95298582086E-01 6.01353270600E-01 6.07471301985E-01 6.13653404194E-01 6.19900309444E-01 6.26212771090E-01 6.32591559562E-01 6.39037429838E-01 6.45551175310E-01 6.52133583688E-01 6.58785473163E-01 6.65507656888E-01 6.72300974097E-01 6.79166272394E-01 6.86104400329E-01 6.93116247750E-01 7.00202687776E-01 7.07364640906E-01 7.14603011840E-01 7.21918749505E-01 7.29312786513E-01 7.36786094237E-01 7.44339663408E-01 7.51974491127E-01 7.59691577774E-01 7.67491981729E-01 7.75376742906E-01 7.83346938157E-01 7.91403666505E-01 7.99548028356E-01 8.07781161841E-01 8.16104231516E-01 8.24518387162E-01 8.33024867023E-01 8.41624845420E-01 8.50319609524E-01 8.59110403931E-01 8.67998529630E-01 8.76985312250E-01 8.86072098601E-01 8.95260251662E-01 9.04551195420E-01 9.13946333104E-01 9.23447150669E-01 9.33055134681E-01 9.42771802314E-01 9.52598710781E-01 9.62537465335E-01 9.72589666647E-01 9.82756990430E-01 9.93041127915E-01 1.00344381978E+00 1.01396683036E+00 1.02461198024E+00 1.03538111900E+00 1.04627614554E+00 1.05729900523E+00 1.06845167730E+00 1.07973619307E+00 1.09115462924E+00 1.10270912648E+00 1.11440185392E+00 1.12623503879E+00 1.13821097966E+00 1.15033200675E+00 1.16260052117E+00 1.17501897100E+00 1.18758986708E+00 1.20031579897E+00 1.21319939504E+00 1.22624337276E+00 1.23945048105E+00 1.25282358308E+00 1.26636557386E+00 1.28007943844E+00 1.29396824695E+00 1.30803511330E+00 1.32228325749E+00 1.33671596358E+00 1.35133662402E+00 1.36614866787E+00 1.38115566659E+00 1.39636122945E+00 1.41176908210E+00 1.42738303625E+00 1.44320699722E+00 1.45924496109E+00 1.47550103448E+00 1.49197940179E+00 1.50868436599E+00 1.52562032010E+00 1.54279177771E+00 1.56020332779E+00 1.57785969262E+00 1.59576569090E+00 1.61392625102E+00 1.63234641215E+00 1.65103131000E+00 1.66998621731E+00 1.68921648692E+00 1.70872760536E+00 1.72852515726E+00 1.74861483888E+00 1.76900245556E+00 1.78969391451E+00 1.81069523221E+00 1.83201252339E+00 1.85365202229E+00 1.87562002105E+00 1.89792293908E+00 1.92056726246E+00 1.94355957125E+00 1.96690651658E+00 1.99061481885E+00 2.01469126532E+00 2.03914268838E+00 2.06397597406E+00 2.08919802128E+00 2.11481577162E+00 2.14083616622E+00 2.16726613430E+00 2.19411258643E+00 2.22138238842E+00 2.24908235405E+00 2.27721920710E+00 2.30579957335E+00 2.33482994278E+00 2.36431666441E+00 2.39426588944E+00 2.42468355650E+00 2.45557535634E+00 2.48694669353E+00 2.51880264469E+00 2.55114791799E+00 2.58398680740E+00 2.61732314950E+00 2.65116025101E+00 2.68550086576E+00 2.72034710030E+00 2.75570037996E+00 2.79156135671E+00 2.82792985159E+00 2.86480476740E+00 2.90218402015E+00 2.94006444150E+00 2.97844169066E+00 3.01731014907E+00 3.05666283470E+00 3.09649127330E+00 3.13678539496E+00 3.17753342529E+00 3.21872172100E+00 3.26033468016E+00 3.30235456854E+00 3.34476139892E+00 3.38753275081E+00 3.43064363316E+00 3.47406631040E+00 3.51777011324E+00 3.56172128241E+00 3.60588276121E+00 3.65021401016E+00 3.69467079867E+00 3.73920500220E+00 3.78376438850E+00 3.82829239223E+00 3.87272789195E+00 3.91700497526E+00 3.96105271474E+00 4.00479491422E+00 4.04814986854E+00 4.09103012988E+00 4.13334224111E+00 4.17498650761E+00 4.21585674130E+00 4.25584001242E+00 4.29481641705E+00 4.33265883635E+00 4.36923270748E+00 4.40439580184E+00 4.43799802128E+00 4.46988119849E+00 4.49987891600E+00 4.52781634782E+00 4.55351011663E+00 4.57676818515E+00 4.59738975953E+00 4.61516524141E+00 4.62987621103E+00 4.64129543942E+00 4.64918695811E+00 4.65330617443E+00 4.65340003405E+00 4.64920725323E+00 4.64045859746E+00 4.62687725399E+00 4.60817925323E+00 4.58407399100E+00 4.55426482769E+00 4.51844978310E+00 4.47632232681E+00 4.42757228260E+00 4.37188683296E+00 4.30895165146E+00 4.23845214569E+00 4.16007485254E+00 4.07350894162E+00 3.97844788279E+00 3.87459123830E+00 3.76164662700E+00 3.63933182889E+00 3.50737704635E+00 3.36552733318E+00 3.21354518006E+00 3.05121326168E+00 2.87833734770E+00 2.69474936979E+00 2.50031064149E+00 2.29491523463E+00 2.07849348803E+00 1.85101565912E+00 1.61249568715E+00 1.36299506615E+00 1.10262680965E+00 8.31559478161E-01 5.50021261020E-01 2.58304068158E-01 -4.32323863084E-02 -3.54156541559E-01 -6.73961039118E-01 -1.00205889749E+00 -1.33777986009E+00 -1.68036697480E+00 -2.02897345821E+00 -2.38265991489E+00 -2.74039196719E+00 -3.10103839169E+00 -3.46336982620E+00 -3.82605814265E+00 -4.18767657990E+00 -4.54670073808E+00 -4.90151053557E+00 -5.25039325516E+00 -5.59154778087E+00 -5.92309016641E+00 -6.24306065635E+00 -6.54943229579E+00 -6.84012126431E+00 -7.11299907674E+00 -7.36590677774E+00 -7.59667127019E+00 -7.80312390649E+00 -7.98312144615E+00 -8.13456948764E+00 -8.25544845064E+00 -8.34384214755E+00 -8.39796896081E+00 -8.41621556929E+00 -8.39717313502E+00 -8.33967574070E+00 -8.24284081326E+00 -8.10611111689E+00 -7.92929776455E+00 -7.71262352574E+00 -7.45676548058E+00 -7.16289583264E+00 -6.83271937442E+00 -6.46850575389E+00 -6.07311424791E+00 -5.65000826817E+00 -5.20325620444E+00 -4.73751454913E+00 -4.25798839344E+00 -3.77036346835E+00 -3.28070274471E+00 -2.79529933377E+00 -2.32047585809E+00 -1.86231870574E+00 -1.42633345442E+00 -1.01700532684E+00 -6.37245682021E-01 -2.87702242335E-01 3.23145171853E-02 3.18833015639E-01 5.66217553195E-01 7.68594046867E-01 9.19866162643E-01 1.01373495407E+00 1.04372100460E+00 1.00319918322E+00 8.85350041277E-01 6.83965917311E-01 3.85966128886E-01 4.48076177308E-02 -4.71424602858E-03 2.07111404169E-04 -2.88939238408E-04 -2.45294086809E-04 -2.54800514497E-04 -2.58477678494E-04 -2.62212353537E-04 -2.65435892644E-04 -2.68222113651E-04 -2.70580839347E-04 2 0 Beta L 865 1.05431856352E-03 1.06491467538E-03 1.07561728096E-03 1.08642745059E-03 1.09727649145E-03 1.10866072808E-03 1.11973106896E-03 1.13039247746E-03 1.14239401742E-03 1.15342843819E-03 1.16493276224E-03 1.17709042769E-03 1.18863472070E-03 1.20078399447E-03 1.21272633952E-03 1.22508081610E-03 1.23710237224E-03 1.24996234420E-03 1.26198761122E-03 1.27503892463E-03 1.28752849942E-03 1.30102359042E-03 1.31347050484E-03 1.32704663484E-03 1.34003899277E-03 1.35370077609E-03 1.36735228156E-03 1.38140409166E-03 1.39479759544E-03 1.40899190207E-03 1.42303715121E-03 1.43742040986E-03 1.45190521306E-03 1.46643051093E-03 1.48138356632E-03 1.49574148544E-03 1.51133765090E-03 1.52625419160E-03 1.54194289385E-03 1.55708065007E-03 1.57300677255E-03 1.58860788094E-03 1.60482108702E-03 1.62058239086E-03 1.63706647640E-03 1.65344839489E-03 1.67007728468E-03 1.68681017915E-03 1.70374881009E-03 1.72096683581E-03 1.73802938131E-03 1.75575060532E-03 1.77337998188E-03 1.79133897765E-03 1.80932750287E-03 1.82758786565E-03 1.84579544920E-03 1.86424282563E-03 1.88295745944E-03 1.90198640503E-03 1.92099393753E-03 1.94056422312E-03 1.95996834443E-03 1.97952822717E-03 1.99956204379E-03 2.01975020403E-03 2.03991449570E-03 2.06060028839E-03 2.08112748663E-03 2.10209632909E-03 2.12303300701E-03 2.14457624017E-03 2.16626584736E-03 2.18761434796E-03 2.20994826373E-03 2.23204943174E-03 2.25447874837E-03 2.27700883697E-03 2.30001954409E-03 2.32296404282E-03 2.34634404219E-03 2.37016328557E-03 2.39392901948E-03 2.41770023791E-03 2.44218911772E-03 2.46675626086E-03 2.49151492832E-03 2.51676421078E-03 2.54198346461E-03 2.56744941071E-03 2.59318911533E-03 2.61915064313E-03 2.64555795861E-03 2.67203956123E-03 2.69908658430E-03 2.72623459102E-03 2.75347744289E-03 2.78123212964E-03 2.80895234081E-03 2.83756883080E-03 2.86592298577E-03 2.89493161592E-03 2.92375364122E-03 2.95308868390E-03 2.98289790449E-03 3.01286326657E-03 3.04317770305E-03 3.07370134921E-03 3.10470831877E-03 3.13587573136E-03 3.16732162496E-03 3.19931067205E-03 3.23131511844E-03 3.26381916524E-03 3.29670627235E-03 3.32974274301E-03 3.36332685917E-03 3.39696469585E-03 3.43133830397E-03 3.46563493125E-03 3.50042131404E-03 3.53564359201E-03 3.57118000971E-03 3.60707540380E-03 3.64336629156E-03 3.67981624770E-03 3.71714270799E-03 3.75411441703E-03 3.79206687796E-03 3.83017018822E-03 3.86866891051E-03 3.90736669964E-03 3.94678924140E-03 3.98634756280E-03 4.02647353811E-03 4.06684255101E-03 4.10772567390E-03 4.14915999868E-03 4.19074578600E-03 4.23295950257E-03 4.27541163335E-03 4.31833006156E-03 4.36191632404E-03 4.40554660273E-03 4.45002999388E-03 4.49462622652E-03 4.53980454930E-03 4.58557003908E-03 4.63150973433E-03 4.67814990853E-03 4.72505331757E-03 4.77262931603E-03 4.82046228746E-03 4.86899821972E-03 4.91796500581E-03 4.96737599185E-03 5.01731184365E-03 5.06770583044E-03 5.11865402499E-03 5.17016659929E-03 5.22211019818E-03 5.27455383599E-03 5.32763012635E-03 5.38111372334E-03 5.43512890500E-03 5.48975478011E-03 5.54497985548E-03 5.60067977372E-03 5.65700451748E-03 5.71388599179E-03 5.77126260119E-03 5.82926091199E-03 5.88787026337E-03 5.94700256983E-03 6.00682301380E-03 6.06720863392E-03 6.12808953192E-03 6.18978778671E-03 6.25190181200E-03 6.31483036968E-03 6.37822111152E-03 6.44233255681E-03 6.50710340180E-03 6.57253179912E-03 6.63855583319E-03 6.70534931606E-03 6.77261025265E-03 6.84072338703E-03 6.90946591105E-03 6.97882270538E-03 7.04913767477E-03 7.11990169931E-03 7.19143794880E-03 7.26368783789E-03 7.33675748523E-03 7.41052229183E-03 7.48489833939E-03 7.56020300666E-03 7.63613045164E-03 7.71293578700E-03 7.79046528867E-03 7.86866715286E-03 7.94778612214E-03 8.02767804240E-03 8.10832389459E-03 8.18987715594E-03 8.27212038421E-03 8.35528649735E-03 8.43925741351E-03 8.52407331139E-03 8.60972930137E-03 8.69628140498E-03 8.78366806803E-03 8.87194404922E-03 8.96110496696E-03 9.05114584153E-03 9.14216289871E-03 9.23405888125E-03 9.32678574003E-03 9.42059549980E-03 9.51519672051E-03 9.61088156531E-03 9.70749597080E-03 9.80499547733E-03 9.90356231366E-03 1.00030935558E-02 1.01036021622E-02 1.02051712852E-02 1.03077153101E-02 1.04113155211E-02 1.05159720752E-02 1.06216682524E-02 1.07284117333E-02 1.08362230719E-02 1.09451302577E-02 1.10551112229E-02 1.11661918627E-02 1.12785159209E-02 1.13918204943E-02 1.15063329470E-02 1.16219350575E-02 1.17387790033E-02 1.18567293569E-02 1.19759101391E-02 1.20962250727E-02 1.22178268355E-02 1.23406098582E-02 1.24646487608E-02 1.25898857138E-02 1.27164648225E-02 1.28442064690E-02 1.29733825461E-02 1.31036716605E-02 1.32354250293E-02 1.33684087709E-02 1.35027822035E-02 1.36385014309E-02 1.37755675224E-02 1.39139785047E-02 1.40538369412E-02 1.41950814009E-02 1.43377557729E-02 1.44818363341E-02 1.46273944899E-02 1.47744129632E-02 1.49228595508E-02 1.50728708969E-02 1.52243555949E-02 1.53773589520E-02 1.55319387401E-02 1.56880308378E-02 1.58457000973E-02 1.60049208091E-02 1.61657714074E-02 1.63282384321E-02 1.64923880541E-02 1.66581227686E-02 1.68255319274E-02 1.69946444352E-02 1.71654490393E-02 1.73379143702E-02 1.75122422346E-02 1.76881819445E-02 1.78659712276E-02 1.80455334888E-02 1.82268742549E-02 1.84101062117E-02 1.85951221891E-02 1.87819828778E-02 1.89707777321E-02 1.91614176467E-02 1.93539765792E-02 1.95485311519E-02 1.97449810747E-02 1.99434251896E-02 2.01438615460E-02 2.03463239080E-02 2.05507977502E-02 2.07573456628E-02 2.09659713123E-02 2.11766815345E-02 2.13895190518E-02 2.16044678557E-02 2.18216347614E-02 2.20409085352E-02 2.22624607378E-02 2.24862024047E-02 2.27121869023E-02 2.29404662384E-02 2.31710179839E-02 2.34038924184E-02 2.36391010552E-02 2.38766885861E-02 2.41166646502E-02 2.43590194710E-02 2.46038613231E-02 2.48511217658E-02 2.51008791131E-02 2.53531680095E-02 2.56079761873E-02 2.58653435755E-02 2.61253061491E-02 2.63878677398E-02 2.66530730726E-02 2.69209456486E-02 2.71915548163E-02 2.74647981320E-02 2.77408410084E-02 2.80196547649E-02 2.83012692624E-02 2.85856987156E-02 2.88730090567E-02 2.91631822882E-02 2.94562916265E-02 2.97523356570E-02 3.00513638063E-02 3.03533912178E-02 3.06584573040E-02 3.09665983617E-02 3.12778307998E-02 3.15921781058E-02 3.19096908682E-02 3.22304038155E-02 3.25543381017E-02 3.28815364207E-02 3.32120088330E-02 3.35458009401E-02 3.38829575172E-02 3.42234893739E-02 3.45674595051E-02 3.49148790190E-02 3.52658146480E-02 3.56202368295E-02 3.59782495841E-02 3.63398411025E-02 3.67050876052E-02 3.70740070043E-02 3.74466033286E-02 3.78229827787E-02 3.82031216720E-02 3.85870840899E-02 3.89749198841E-02 3.93666230263E-02 3.97623090274E-02 4.01619391129E-02 4.05656043139E-02 4.09733121614E-02 4.13851226044E-02 4.18010915636E-02 4.22212089166E-02 4.26455639857E-02 4.30741885088E-02 4.35071062360E-02 4.39443916283E-02 4.43860806382E-02 4.48321925058E-02 4.52828006670E-02 4.57379150021E-02 4.61976278656E-02 4.66619659186E-02 4.71309495257E-02 4.76046684306E-02 4.80831341023E-02 4.85664210809E-02 4.90545529308E-02 4.95476135347E-02 5.00456025744E-02 5.05486291444E-02 5.10566772109E-02 5.15698613531E-02 5.20881866981E-02 5.26117302687E-02 5.31405419725E-02 5.36746569071E-02 5.42141522451E-02 5.47590708183E-02 5.53094684944E-02 5.58653851841E-02 5.64269089730E-02 5.69940731522E-02 5.75669318071E-02 5.81455547494E-02 5.87299970317E-02 5.93203129003E-02 5.99165685058E-02 6.05188056114E-02 6.11271090073E-02 6.17415242729E-02 6.23621217274E-02 6.29889410475E-02 6.36220980627E-02 6.42615918229E-02 6.49075124429E-02 6.55599416537E-02 6.62189283753E-02 6.68845357210E-02 6.75568421213E-02 6.82359073495E-02 6.89217961993E-02 6.96145892241E-02 7.03143459587E-02 7.10211305520E-02 7.17350261678E-02 7.24561104516E-02 7.31844327856E-02 7.39200776280E-02 7.46631348180E-02 7.54136494154E-02 7.61717242042E-02 7.69374136216E-02 7.77108044617E-02 7.84919705642E-02 7.92809969141E-02 8.00779624926E-02 8.08829274960E-02 8.16960110518E-02 8.25172501009E-02 8.33467626307E-02 8.41846096306E-02 8.50308877235E-02 8.58856797483E-02 8.67490636214E-02 8.76211341060E-02 8.85019753801E-02 8.93916756664E-02 9.02903279413E-02 9.11980122418E-02 9.21148382347E-02 9.30408783115E-02 9.39762360507E-02 9.49210093489E-02 9.58752780093E-02 9.68391515324E-02 9.78127163404E-02 9.87960795794E-02 9.97893389255E-02 1.00792579135E-01 1.01805934096E-01 1.02829462981E-01 1.03863304923E-01 1.04907545110E-01 1.05962287097E-01 1.07027652453E-01 1.08103724109E-01 1.09190634068E-01 1.10288477507E-01 1.11397375843E-01 1.12517425359E-01 1.13648751862E-01 1.14791463888E-01 1.15945675968E-01 1.17111502852E-01 1.18289069554E-01 1.19478480353E-01 1.20679870488E-01 1.21893358544E-01 1.23119052230E-01 1.24357091249E-01 1.25607589226E-01 1.26870679154E-01 1.28146483193E-01 1.29435140107E-01 1.30736766419E-01 1.32051499832E-01 1.33379471864E-01 1.34720818802E-01 1.36075667640E-01 1.37444170553E-01 1.38826451777E-01 1.40222655970E-01 1.41632919636E-01 1.43057396511E-01 1.44496216764E-01 1.45949530963E-01 1.47417489985E-01 1.48900241232E-01 1.50397927763E-01 1.51910705280E-01 1.53438728204E-01 1.54982150195E-01 1.56541126716E-01 1.58115816041E-01 1.59706371495E-01 1.61312967256E-01 1.62935756435E-01 1.64574905887E-01 1.66230578736E-01 1.67902948343E-01 1.69592182233E-01 1.71298446976E-01 1.73021925068E-01 1.74762783630E-01 1.76521203942E-01 1.78297359482E-01 1.80091436197E-01 1.81903613257E-01 1.83734078300E-01 1.85583011702E-01 1.87450604329E-01 1.89337051314E-01 1.91242539692E-01 1.93167265692E-01 1.95111424875E-01 1.97075213823E-01 1.99058836114E-01 2.01062491836E-01 2.03086389444E-01 2.05130733325E-01 2.07195728005E-01 2.09281592878E-01 2.11388539492E-01 2.13516779496E-01 2.15666536512E-01 2.17838025005E-01 2.20031476076E-01 2.22247108305E-01 2.24485156095E-01 2.26745836776E-01 2.29029401913E-01 2.31336070146E-01 2.33666089398E-01 2.36019694273E-01 2.38397133911E-01 2.40798647919E-01 2.43224490426E-01 2.45674905799E-01 2.48150157643E-01 2.50650492286E-01 2.53176173640E-01 2.55727469340E-01 2.58304637799E-01 2.60907952969E-01 2.63537677921E-01 2.66194099226E-01 2.68877485768E-01 2.71588118734E-01 2.74326285943E-01 2.77092272575E-01 2.79886370049E-01 2.82708871134E-01 2.85560072533E-01 2.88440277323E-01 2.91349787739E-01 2.94288911955E-01 2.97257961508E-01 3.00257249774E-01 3.03287096557E-01 3.06347826860E-01 3.09439762582E-01 3.12563236284E-01 3.15718580081E-01 3.18906134632E-01 3.22126240092E-01 3.25379244255E-01 3.28665497818E-01 3.31985352431E-01 3.35339171241E-01 3.38727313739E-01 3.42150152517E-01 3.45608056610E-01 3.49101407279E-01 3.52630582187E-01 3.56195969646E-01 3.59797963635E-01 3.63436960291E-01 3.67113357188E-01 3.70827567450E-01 3.74579999871E-01 3.78371073350E-01 3.82201212833E-01 3.86070844060E-01 3.89980402932E-01 3.93930332423E-01 3.97921071993E-01 4.01953084215E-01 4.06026815205E-01 4.10142740520E-01 4.14301324727E-01 4.18503046869E-01 4.22748392537E-01 4.27037852515E-01 4.31371921607E-01 4.35751110236E-01 4.40175922968E-01 4.44646885576E-01 4.49164523315E-01 4.53729368928E-01 4.58341964682E-01 4.63002864778E-01 4.67712621072E-01 4.72471804109E-01 4.77280987257E-01 4.82140755529E-01 4.87051698734E-01 4.92014419831E-01 4.97029527653E-01 5.02097642178E-01 5.07219393476E-01 5.12395418394E-01 5.17626365145E-01 5.22912891257E-01 5.28255668408E-01 5.33655372843E-01 5.39112693063E-01 5.44628332891E-01 5.50203001028E-01 5.55837421066E-01 5.61532324935E-01 5.67288456909E-01 5.73106577354E-01 5.78987452157E-01 5.84931865584E-01 5.90940604892E-01 5.97014481630E-01 6.03154309856E-01 6.09360920977E-01 6.15635162120E-01 6.21977885063E-01 6.28389961882E-01 6.34872273977E-01 6.41425722838E-01 6.48051211246E-01 6.54749670085E-01 6.61522030985E-01 6.68369245966E-01 6.75292279346E-01 6.82292108968E-01 6.89369725049E-01 6.96526134732E-01 7.03762352990E-01 7.11079412656E-01 7.18478356288E-01 7.25960243598E-01 7.33526138937E-01 7.41177125681E-01 7.48914295876E-01 7.56738753000E-01 7.64651611428E-01 7.72653991888E-01 7.80747031242E-01 7.88931866683E-01 7.97209648879E-01 8.05581531757E-01 8.14048674971E-01 8.22612242339E-01 8.31273398897E-01 8.40033311740E-01 8.48893146056E-01 8.57854069545E-01 8.66917235147E-01 8.76083797939E-01 8.85354898054E-01 8.94731666547E-01 9.04215218057E-01 9.13806649001E-01 9.23507035525E-01 9.33317426353E-01 9.43238843601E-01 9.53272270567E-01 9.63418657923E-01 9.73678910902E-01 9.84053884665E-01 9.94544380853E-01 1.00515113903E+00 1.01587483307E+00 1.02671605948E+00 1.03767533346E+00 1.04875307715E+00 1.05994961647E+00 1.07126516435E+00 1.08269981492E+00 1.09425353233E+00 1.10592613878E+00 1.11771730158E+00 1.12962652067E+00 1.14165311449E+00 1.15379620677E+00 1.16605470560E+00 1.17842729527E+00 1.19091240969E+00 1.20350822152E+00 1.21621261605E+00 1.22902317432E+00 1.24193714826E+00 1.25495144101E+00 1.26806257962E+00 1.28126669015E+00 1.29455946869E+00 1.30793615715E+00 1.32139150826E+00 1.33491975705E+00 1.34851459127E+00 1.36216910718E+00 1.37587578515E+00 1.38962644346E+00 1.40341220611E+00 1.41722345532E+00 1.43104979534E+00 1.44488000706E+00 1.45870199886E+00 1.47250276623E+00 1.48626833849E+00 1.49998373146E+00 1.51363289456E+00 1.52719865964E+00 1.54066268742E+00 1.55400541126E+00 1.56720598208E+00 1.58024221044E+00 1.59309051230E+00 1.60572584718E+00 1.61812166068E+00 1.63024982917E+00 1.64208059652E+00 1.65358252150E+00 1.66472241864E+00 1.67546530181E+00 1.68577433259E+00 1.69561076734E+00 1.70493390806E+00 1.71370105589E+00 1.72186747036E+00 1.72938633040E+00 1.73620870120E+00 1.74228350787E+00 1.74755751407E+00 1.75197531058E+00 1.75547930778E+00 1.75800974210E+00 1.75950469122E+00 1.75990009807E+00 1.75912981064E+00 1.75712563473E+00 1.75381739999E+00 1.74913304493E+00 1.74299871502E+00 1.73533888617E+00 1.72607650159E+00 1.71513313589E+00 1.70242917981E+00 1.68788405051E+00 1.67141642742E+00 1.65294451808E+00 1.63238635057E+00 1.60966009940E+00 1.58468444031E+00 1.55737894476E+00 1.52766450240E+00 1.49546378583E+00 1.46070174741E+00 1.42330616003E+00 1.38320819359E+00 1.34034303096E+00 1.29465052637E+00 1.24607590279E+00 1.19457048943E+00 1.14009249979E+00 1.08260784770E+00 1.02209100045E+00 9.58525869443E-01 8.91906731870E-01 8.22239185768E-01 7.49541129997E-01 6.73843768212E-01 5.95192631957E-01 5.13648614773E-01 4.29289014952E-01 3.42208574883E-01 2.52520511982E-01 1.60357532308E-01 6.58728133341E-02 -3.07590532263E-02 -1.29341171319E-01 -2.29653518635E-01 -3.31452206876E-01 -4.34468842790E-01 -5.38410004601E-01 -6.42956858935E-01 -7.47764935031E-01 -8.52464080968E-01 -9.56658626489E-01 -1.05992777859E+00 -1.16182627614E+00 -1.26188533600E+00 -1.35961391684E+00 -1.45450033662E+00 -1.54601427474E+00 -1.63360919326E+00 -1.71672521167E+00 -1.79479247091E+00 -1.86723501867E+00 -1.93347525031E+00 -1.99293893761E+00 -2.04506086974E+00 -2.08929113231E+00 -2.12510204143E+00 -2.15199573984E+00 -2.16951245581E+00 -2.17723940634E+00 -2.17482031692E+00 -2.16196549899E+00 -2.13846241070E+00 -2.10418658708E+00 -2.05911279037E+00 -2.00332618587E+00 -1.93703328961E+00 -1.86057237169E+00 -1.77442291612E+00 -1.67921364806E+00 -1.57572852427E+00 -1.46490995757E+00 -1.34785838552E+00 -1.22582712166E+00 -1.10021120691E+00 -9.72528741187E-01 -8.44392875395E-01 -7.17472314900E-01 -5.93437779298E-01 -4.73891409196E-01 -3.60275561399E-01 -2.53756807357E-01 -1.55080211961E-01 -6.43881164590E-02 1.85304824991E-02 9.26449265453E-02 1.56483893766E-01 2.08515172407E-01 2.47149924910E-01 2.70747861897E-01 2.77623060116E-01 2.66053085864E-01 2.34266142592E-01 1.80653336504E-01 1.01797019321E-01 1.18077035937E-02 -1.23694797709E-03 5.92239387989E-05 -7.15940383996E-05 -6.02485249404E-05 -6.29006192171E-05 -6.40141764206E-05 -6.51397627434E-05 -6.61275419345E-05 -6.69969182542E-05 -6.77504496218E-05 3 1 Beta L 865 -1.15933289415E-05 -1.18275297351E-05 -1.20664616991E-05 -1.23102204096E-05 -1.25589033732E-05 -1.28126100666E-05 -1.30714419758E-05 -1.33355026371E-05 -1.36048976784E-05 -1.38797348611E-05 -1.41601241241E-05 -1.44461776266E-05 -1.47380097941E-05 -1.50357373633E-05 -1.53394794292E-05 -1.56493574929E-05 -1.59654955096E-05 -1.62880199389E-05 -1.66170597950E-05 -1.69527466981E-05 -1.72952149277E-05 -1.76446014756E-05 -1.80010461012E-05 -1.83646913872E-05 -1.87356827966E-05 -1.91141687310E-05 -1.95003005899E-05 -1.98942328313E-05 -2.02961230334E-05 -2.07061319578E-05 -2.11244236136E-05 -2.15511653231E-05 -2.19865277889E-05 -2.24306851617E-05 -2.28838151108E-05 -2.33460988940E-05 -2.38177214314E-05 -2.42988713782E-05 -2.47897412010E-05 -2.52905272545E-05 -2.58014298599E-05 -2.63226533852E-05 -2.68544063270E-05 -2.73969013935E-05 -2.79503555904E-05 -2.85149903068E-05 -2.90910314043E-05 -2.96787093073E-05 -3.02782590949E-05 -3.08899205953E-05 -3.15139384815E-05 -3.21505623691E-05 -3.27363885158E-05 -3.33935184020E-05 -3.40721520429E-05 -3.47612710208E-05 -3.54675586396E-05 -3.61792241408E-05 -3.69155631155E-05 -3.76612858657E-05 -3.84285803812E-05 -3.91988267776E-05 -3.99970492137E-05 -4.08048275764E-05 -4.16325279912E-05 -4.24699159248E-05 -4.33336945531E-05 -4.42077388678E-05 -4.51060426182E-05 -4.60132892803E-05 -4.69484839828E-05 -4.78946854583E-05 -4.88679007228E-05 -4.98514364174E-05 -5.08625464249E-05 -5.18906600645E-05 -5.29418075342E-05 -5.40685992640E-05 -5.51619520519E-05 -5.62750772675E-05 -5.74111169387E-05 -5.85732951239E-05 -5.97549465612E-05 -6.09628031210E-05 -6.21945928581E-05 -6.34493957212E-05 -6.47318229957E-05 -6.60409536310E-05 -6.73751032092E-05 -6.87361366438E-05 -7.01253022307E-05 -7.15430718744E-05 -7.29868591270E-05 -7.44626833721E-05 -7.59657183576E-05 -7.75024610991E-05 -7.90674254461E-05 -8.06640369857E-05 -8.22943250034E-05 -8.39575841513E-05 -8.56552120865E-05 -8.73839557973E-05 -8.91501715969E-05 -9.09501412946E-05 -9.27867971049E-05 -9.46646133002E-05 -9.65761127775E-05 -9.85250187866E-05 -1.00519204261E-04 -1.02547707634E-04 -1.04620976330E-04 -1.06732919841E-04 -1.08891564024E-04 -1.11088324570E-04 -1.13334580738E-04 -1.15623480675E-04 -1.17959715314E-04 -1.20342849501E-04 -1.22775549178E-04 -1.25253888817E-04 -1.27785733096E-04 -1.30367697671E-04 -1.33001150745E-04 -1.35687347431E-04 -1.38429049548E-04 -1.41225070906E-04 -1.44079677651E-04 -1.46988704030E-04 -1.49959923364E-04 -1.52990194671E-04 -1.56078694882E-04 -1.59234073299E-04 -1.62448878141E-04 -1.65730359404E-04 -1.69080529118E-04 -1.72494206820E-04 -1.75979834196E-04 -1.79532771217E-04 -1.83163767487E-04 -1.86862666311E-04 -1.90638123493E-04 -1.94490228038E-04 -1.98417409610E-04 -2.02427996327E-04 -2.06516517098E-04 -2.10690430485E-04 -2.14944772187E-04 -2.19288191371E-04 -2.23717998755E-04 -2.28237990244E-04 -2.32846161629E-04 -2.37553443443E-04 -2.42349704230E-04 -2.47247993651E-04 -2.52242360478E-04 -2.57335754091E-04 -2.62536952061E-04 -2.67839838360E-04 -2.73250991787E-04 -2.78770848336E-04 -2.84402599291E-04 -2.90149440628E-04 -2.96008991696E-04 -3.01989322822E-04 -3.08091487742E-04 -3.14313280376E-04 -3.20665344788E-04 -3.27141978459E-04 -3.33751308461E-04 -3.40493796196E-04 -3.47373477660E-04 -3.54388201555E-04 -3.61550599242E-04 -3.68854139232E-04 -3.76306455492E-04 -3.83905821602E-04 -3.91665775303E-04 -3.99573770275E-04 -4.07647226194E-04 -4.15883809780E-04 -4.24282026619E-04 -4.32857031784E-04 -4.41599674560E-04 -4.50521284639E-04 -4.59623614345E-04 -4.68908359893E-04 -4.78379980040E-04 -4.88045290069E-04 -4.97902645537E-04 -5.07962667847E-04 -5.18224431874E-04 -5.28692317873E-04 -5.39375179816E-04 -5.50269564592E-04 -5.61386056203E-04 -5.72727831669E-04 -5.84296446235E-04 -5.96101300835E-04 -6.08143201800E-04 -6.20427956513E-04 -6.32963431153E-04 -6.45747557057E-04 -6.58794617007E-04 -6.72103703208E-04 -6.85680661331E-04 -6.99533150320E-04 -7.13661578556E-04 -7.28080893527E-04 -7.42789249861E-04 -7.57797193551E-04 -7.73102364920E-04 -7.88722338470E-04 -8.04653563727E-04 -8.20913285962E-04 -8.37492296727E-04 -8.54413223793E-04 -8.71672267771E-04 -8.89283211604E-04 -9.07247857196E-04 -9.25573567493E-04 -9.44273666323E-04 -9.63347915279E-04 -9.82811733151E-04 -1.00266171386E-03 -1.02291978703E-03 -1.04358653072E-03 -1.06466268166E-03 -1.08617220426E-03 -1.10811453723E-03 -1.13050078729E-03 -1.15334004365E-03 -1.17663709120E-03 -1.20040724948E-03 -1.22465761196E-03 -1.24939887979E-03 -1.27463504673E-03 -1.30038734413E-03 -1.32665514736E-03 -1.35345492892E-03 -1.38079869979E-03 -1.40869240389E-03 -1.43714860427E-03 -1.46618119290E-03 -1.49580060332E-03 -1.52601835907E-03 -1.55684398820E-03 -1.58829604304E-03 -1.62038081508E-03 -1.65311385768E-03 -1.68650997113E-03 -1.72057856072E-03 -1.75533833587E-03 -1.79079719183E-03 -1.82697425617E-03 -1.86388292460E-03 -1.90153535107E-03 -1.93994671183E-03 -1.97913673473E-03 -2.01911997010E-03 -2.05990472442E-03 -2.10152050744E-03 -2.14397446016E-03 -2.18728441122E-03 -2.23146938460E-03 -2.27654688557E-03 -2.32253802185E-03 -2.36945628946E-03 -2.41732244212E-03 -2.46615424004E-03 -2.51597333014E-03 -2.56680045787E-03 -2.61865225319E-03 -2.67155151026E-03 -2.72552003119E-03 -2.78057759838E-03 -2.83675069574E-03 -2.89405589269E-03 -2.95251949535E-03 -3.01216279764E-03 -3.07301247877E-03 -3.13508914040E-03 -3.19842223397E-03 -3.26303429890E-03 -3.32895029901E-03 -3.39620103926E-03 -3.46480519496E-03 -3.53479904584E-03 -3.60620754942E-03 -3.67905330354E-03 -3.75337576679E-03 -3.82919840920E-03 -3.90655254600E-03 -3.98546690553E-03 -4.06597929822E-03 -4.14811572364E-03 -4.23191280479E-03 -4.31740166119E-03 -4.40461725638E-03 -4.49359451111E-03 -4.58437010513E-03 -4.67697803941E-03 -4.77146020006E-03 -4.86784833173E-03 -4.96618281061E-03 -5.06650287003E-03 -5.16885164883E-03 -5.27326939959E-03 -5.37979247451E-03 -5.48846918086E-03 -5.59933962940E-03 -5.71245309092E-03 -5.82784941460E-03 -5.94557623464E-03 -6.06568424613E-03 -6.18821036944E-03 -6.31322267311E-03 -6.44075325399E-03 -6.57086154468E-03 -6.70359862068E-03 -6.83901499471E-03 -6.97716962536E-03 -7.11811273600E-03 -7.26190492889E-03 -7.40859994000E-03 -7.55825990832E-03 -7.71094400384E-03 -7.86670685307E-03 -8.02562268013E-03 -8.18774308947E-03 -8.35314146700E-03 -8.52187891327E-03 -8.69403029093E-03 -8.86965077378E-03 -9.04882368413E-03 -9.23161545026E-03 -9.41809859063E-03 -9.60835281763E-03 -9.80244465920E-03 -1.00004567973E-02 -1.02024744532E-02 -1.04085662079E-02 -1.06188259341E-02 -1.08333287360E-02 -1.10521677335E-02 -1.12754249691E-02 -1.15031919812E-02 -1.17355611470E-02 -1.19726215996E-02 -1.22144732576E-02 -1.24612103443E-02 -1.27129264649E-02 -1.29697359296E-02 -1.32317250706E-02 -1.34990079883E-02 -1.37716889091E-02 -1.40498803439E-02 -1.43336903851E-02 -1.46232300249E-02 -1.49186236631E-02 -1.52199795242E-02 -1.55274218873E-02 -1.58410760772E-02 -1.61610689898E-02 -1.64875161929E-02 -1.68205665158E-02 -1.71603386773E-02 -1.75069722615E-02 -1.78606121338E-02 -1.82213919500E-02 -1.85894580367E-02 -1.89649611994E-02 -1.93480492935E-02 -1.97388696314E-02 -2.01375871920E-02 -2.05443613803E-02 -2.09593455300E-02 -2.13827137733E-02 -2.18146329972E-02 -2.22552772058E-02 -2.27048156602E-02 -2.31634884508E-02 -2.36312361940E-02 -2.41087434915E-02 -2.45955945483E-02 -2.50925024095E-02 -2.55992241317E-02 -2.61163906458E-02 -2.66439490256E-02 -2.71820838187E-02 -2.77311334512E-02 -2.82912930929E-02 -2.88626363652E-02 -2.94458534966E-02 -3.00403778220E-02 -3.06473527961E-02 -3.12662044396E-02 -3.18978862116E-02 -3.25420927213E-02 -3.31994796545E-02 -3.38699363746E-02 -3.45540922708E-02 -3.52520715968E-02 -3.59641463379E-02 -3.66904933599E-02 -3.74314703070E-02 -3.81877171173E-02 -3.89588344508E-02 -3.97459575386E-02 -4.05484137482E-02 -4.13676615029E-02 -4.22030952209E-02 -4.30555811974E-02 -4.39251500584E-02 -4.48121315308E-02 -4.57175755658E-02 -4.66407065860E-02 -4.75828024027E-02 -4.85437623789E-02 -4.95243837424E-02 -5.05244305580E-02 -5.15449180723E-02 -5.25858918957E-02 -5.36482244964E-02 -5.47314471069E-02 -5.58369508851E-02 -5.69646766091E-02 -5.81150866146E-02 -5.92888291861E-02 -6.04862127426E-02 -6.17078560401E-02 -6.29539615846E-02 -6.42254602349E-02 -6.55226317125E-02 -6.68456722648E-02 -6.81958407965E-02 -6.95730497601E-02 -7.09778361678E-02 -7.24116462090E-02 -7.38736842167E-02 -7.53657352397E-02 -7.68876653767E-02 -7.84402183977E-02 -8.00244816441E-02 -8.16404281921E-02 -8.32891499850E-02 -8.49710527774E-02 -8.66866393125E-02 -8.84377974399E-02 -9.02230383857E-02 -9.20452416937E-02 -9.39038480958E-02 -9.58002693954E-02 -9.77344892724E-02 -9.97079812952E-02 -1.01721456540E-01 -1.03775516280E-01 -1.05870743723E-01 -1.08008660911E-01 -1.10189531921E-01 -1.12414109584E-01 -1.14684489104E-01 -1.16999646836E-01 -1.19361894324E-01 -1.21772325164E-01 -1.24230695286E-01 -1.26738923111E-01 -1.29297916570E-01 -1.31908275215E-01 -1.34571521510E-01 -1.37288318798E-01 -1.40060100119E-01 -1.42887814584E-01 -1.45772637552E-01 -1.48715115545E-01 -1.51717704623E-01 -1.54780479037E-01 -1.57905153128E-01 -1.61092686108E-01 -1.64344654629E-01 -1.67662255082E-01 -1.71046718786E-01 -1.74499548004E-01 -1.78021695322E-01 -1.81615422580E-01 -1.85281141388E-01 -1.89020867277E-01 -1.92836492159E-01 -1.96728197979E-01 -2.00699372487E-01 -2.04749648783E-01 -2.08882457269E-01 -2.13098046656E-01 -2.17398800317E-01 -2.21786321475E-01 -2.26262164165E-01 -2.30828437975E-01 -2.35486484909E-01 -2.40238683433E-01 -2.45086680882E-01 -2.50032096999E-01 -2.55077519764E-01 -2.60224471867E-01 -2.65475198235E-01 -2.70831604524E-01 -2.76296288935E-01 -2.81870684841E-01 -2.87557668588E-01 -2.93359103136E-01 -2.99277474577E-01 -3.05315113169E-01 -3.11474294782E-01 -3.17757609946E-01 -3.24167414407E-01 -3.30706440552E-01 -3.37377035289E-01 -3.44181960067E-01 -3.51124014725E-01 -3.58205859109E-01 -3.65430169018E-01 -3.72799965884E-01 -3.80318201455E-01 -3.87987728077E-01 -3.95811574066E-01 -4.03793008113E-01 -4.11934916131E-01 -4.20240803412E-01 -4.28713690895E-01 -4.37357245270E-01 -4.46174394843E-01 -4.55169232993E-01 -4.64344748276E-01 -4.73704951887E-01 -4.83253298299E-01 -4.92993676993E-01 -5.02930004071E-01 -5.13065894080E-01 -5.23405633239E-01 -5.33953288750E-01 -5.44712803630E-01 -5.55688557539E-01 -5.66884843822E-01 -5.78306127784E-01 -5.89956772084E-01 -6.01841440974E-01 -6.13964782447E-01 -6.26331643268E-01 -6.38946641741E-01 -6.51815042416E-01 -6.64941590443E-01 -6.78331657088E-01 -6.91990429809E-01 -7.05923088268E-01 -7.20135437958E-01 -7.34632660390E-01 -7.49420661635E-01 -7.64505136197E-01 -7.79892007486E-01 -7.95587282364E-01 -8.11597006129E-01 -8.27927548195E-01 -8.44585173051E-01 -8.61576402207E-01 -8.78907859646E-01 -8.96586247047E-01 -9.14618465825E-01 -9.33011533441E-01 -9.51772522002E-01 -9.70908784338E-01 -9.90427668574E-01 -1.01033678198E+00 -1.03064381732E+00 -1.05135652471E+00 -1.07248311483E+00 -1.09403150781E+00 -1.11601017293E+00 -1.13842746764E+00 -1.16129209774E+00 -1.18461281758E+00 -1.20839853423E+00 -1.23265846191E+00 -1.25740182981E+00 -1.28263812204E+00 -1.30837699513E+00 -1.33462826097E+00 -1.36140193998E+00 -1.38870822552E+00 -1.41655753512E+00 -1.44496034802E+00 -1.47392757524E+00 -1.50347006969E+00 -1.53359909027E+00 -1.56432596077E+00 -1.59566230760E+00 -1.62761985745E+00 -1.66021075029E+00 -1.69344706117E+00 -1.72734135067E+00 -1.76190625271E+00 -1.79715464092E+00 -1.83309971136E+00 -1.86975474841E+00 -1.90713338376E+00 -1.94524947963E+00 -1.98411704540E+00 -2.02375047518E+00 -2.06416431319E+00 -2.10537335600E+00 -2.14739274034E+00 -2.19023771189E+00 -2.23392395315E+00 -2.27846728247E+00 -2.32388378575E+00 -2.37018990604E+00 -2.41740230341E+00 -2.46553783437E+00 -2.51461378060E+00 -2.56464760971E+00 -2.61565707198E+00 -2.66766019917E+00 -2.72067533525E+00 -2.77472110885E+00 -2.82981637158E+00 -2.88598035148E+00 -2.94323247823E+00 -3.00159255327E+00 -3.06108059815E+00 -3.12171696367E+00 -3.18352228586E+00 -3.24651746848E+00 -3.31072372097E+00 -3.37616257078E+00 -3.44285573383E+00 -3.51082535746E+00 -3.58009372423E+00 -3.65068351292E+00 -3.72261758089E+00 -3.79591916208E+00 -3.87061165824E+00 -3.94671881681E+00 -4.02426457250E+00 -4.10327320853E+00 -4.18376914649E+00 -4.26577710314E+00 -4.34932205846E+00 -4.43442913271E+00 -4.52112371732E+00 -4.60943140265E+00 -4.69937793581E+00 -4.79098927026E+00 -4.88429151124E+00 -4.97931090332E+00 -5.07607383632E+00 -5.17460680959E+00 -5.27493640442E+00 -5.37708928947E+00 -5.48109218626E+00 -5.58697183162E+00 -5.69475497225E+00 -5.80446833469E+00 -5.91613859506E+00 -6.02979229920E+00 -6.14545596602E+00 -6.26315586694E+00 -6.38291814554E+00 -6.50476867686E+00 -6.62873309310E+00 -6.75483667212E+00 -6.88310436405E+00 -7.01356066871E+00 -7.14622962173E+00 -7.28113473844E+00 -7.41829893332E+00 -7.55774446122E+00 -7.69949285978E+00 -7.84356486992E+00 -7.98998035317E+00 -8.13875822447E+00 -8.28991635531E+00 -8.44347148466E+00 -8.59943913169E+00 -8.75783350443E+00 -8.91866735332E+00 -9.08195190564E+00 -9.24769674618E+00 -9.41590965100E+00 -9.58659651381E+00 -9.75976116926E+00 -9.93540527533E+00 -1.01135281571E+01 -1.02941266419E+01 -1.04771949056E+01 -1.06627243092E+01 -1.08507031896E+01 -1.10411167050E+01 -1.12339466212E+01 -1.14291711062E+01 -1.16267645282E+01 -1.18266972075E+01 -1.20289352229E+01 -1.22334401144E+01 -1.24401686979E+01 -1.26490727329E+01 -1.28600987081E+01 -1.30731875117E+01 -1.32882741769E+01 -1.35052875306E+01 -1.37241499305E+01 -1.39447768887E+01 -1.41670767686E+01 -1.43909504093E+01 -1.46162907796E+01 -1.48429826119E+01 -1.50709019929E+01 -1.52999160060E+01 -1.55298822940E+01 -1.57606486692E+01 -1.59920526834E+01 -1.62239211751E+01 -1.64560698665E+01 -1.66883028856E+01 -1.69204123080E+01 -1.71521777132E+01 -1.73833657068E+01 -1.76137294344E+01 -1.78430081303E+01 -1.80709266277E+01 -1.82971948844E+01 -1.85215075053E+01 -1.87435432816E+01 -1.89629647194E+01 -1.91794175841E+01 -1.93925304673E+01 -1.96019143366E+01 -1.98071621584E+01 -2.00078484686E+01 -2.02035290324E+01 -2.03937405077E+01 -2.05780001122E+01 -2.07558054011E+01 -2.09266340031E+01 -2.10899434703E+01 -2.12451711495E+01 -2.13917341171E+01 -2.15290291770E+01 -2.16564329659E+01 -2.17733020755E+01 -2.18789733253E+01 -2.19727640949E+01 -2.20539727706E+01 -2.21218793147E+01 -2.21757459383E+01 -2.22148179201E+01 -2.22383245780E+01 -2.22454803567E+01 -2.22354861186E+01 -2.22075305941E+01 -2.21607919975E+01 -2.20944398785E+01 -2.20076371491E+01 -2.18995423324E+01 -2.17693120661E+01 -2.16161038323E+01 -2.14390789226E+01 -2.12374057100E+01 -2.10102631534E+01 -2.07568446223E+01 -2.04763619801E+01 -2.01680500053E+01 -1.98311710990E+01 -1.94650203198E+01 -1.90689307360E+01 -1.86422790962E+01 -1.81844918498E+01 -1.76950514683E+01 -1.71735030835E+01 -1.66194614956E+01 -1.60326184066E+01 -1.54127500284E+01 -1.47597249210E+01 -1.40735121181E+01 -1.33541894861E+01 -1.26019522677E+01 -1.18171218512E+01 -1.10001546161E+01 -1.01516509200E+01 -9.27236408947E+00 -8.36320939242E+00 -7.42527295154E+00 -6.45982044985E+00 -5.46830562991E+00 -4.45237841311E+00 -3.41389262151E+00 -2.35491311240E+00 -1.27772224191E+00 -1.84825523981E-01 9.21043663638E-01 2.03692051575E+00 3.15960647577E+00 4.28566843528E+00 5.41143954326E+00 6.53302193359E+00 7.64629151766E+00 8.74690511288E+00 9.83031014941E+00 1.08917572005E+01 1.19263156156E+01 1.29288925021E+01 1.38942554000E+01 1.48170588288E+01 1.56918751013E+01 1.65132295774E+01 1.72756406887E+01 1.79736649353E+01 1.86019470754E+01 1.91552756819E+01 1.96286441781E+01 2.00173173642E+01 2.03169034560E+01 2.05234313757E+01 2.06334330707E+01 2.06440303278E+01 2.05530254028E+01 2.03589944991E+01 2.00613828410E+01 1.96605996629E+01 1.91581110670E+01 1.85565280730E+01 1.78596866381E+01 1.70727156394E+01 1.62020879194E+01 1.52556485015E+01 1.42426128226E+01 1.31735264349E+01 1.20601759127E+01 1.09154387744E+01 9.75305784759E+00 8.58732285522E+00 7.43263873526E+00 6.30295649346E+00 5.21103794139E+00 4.16752051022E+00 3.17974222557E+00 2.25027988675E+00 1.37911192571E+00 5.77016913615E-01 -1.41203956687E-01 -7.59910204603E-01 -1.26264420051E+00 -1.63216288223E+00 -1.85047725340E+00 -1.89892207749E+00 -1.75804763732E+00 -1.40937294242E+00 -8.19123016579E-01 -9.77961198105E-02 9.83856365752E-03 -8.61647873225E-04 2.13939893565E-04 1.17168899271E-04 1.36600366971E-04 1.44007201817E-04 1.52156391149E-04 1.59784171414E-04 1.67023216313E-04 1.73868016767E-04 4 1 Beta L 865 1.08716702551E-05 1.10912925847E-05 1.13153515806E-05 1.15439368694E-05 1.17771398883E-05 1.20150539218E-05 1.22577741385E-05 1.25053976300E-05 1.27580234490E-05 1.30157526493E-05 1.32786883260E-05 1.35469356571E-05 1.38206019450E-05 1.40997966601E-05 1.43846314840E-05 1.46752203545E-05 1.49716795113E-05 1.52741275419E-05 1.55826854297E-05 1.58974766021E-05 1.62186269799E-05 1.65462650276E-05 1.68805218049E-05 1.72215310192E-05 1.75694290787E-05 1.79243551474E-05 1.82864512008E-05 1.86558620821E-05 1.90327355607E-05 1.94172223913E-05 1.98094763739E-05 2.02096544155E-05 2.06179165928E-05 2.10344262162E-05 2.14593498954E-05 2.18928576058E-05 2.23351227563E-05 2.27863222592E-05 2.32466366005E-05 2.37162499123E-05 2.41953500464E-05 2.46841286495E-05 2.51827812399E-05 2.56915072855E-05 2.62105102837E-05 2.67399978431E-05 2.72801817659E-05 2.78312781334E-05 2.83935073916E-05 2.89670944402E-05 2.95522687219E-05 3.01492643147E-05 3.06966105073E-05 3.13126624618E-05 3.19491364210E-05 3.25953427390E-05 3.32577513863E-05 3.39249236721E-05 3.46155553766E-05 3.53148156251E-05 3.60345098231E-05 3.67565784839E-05 3.75052698207E-05 3.82627176089E-05 3.90389603777E-05 3.98240664741E-05 4.06342170526E-05 4.14537698939E-05 4.22962792395E-05 4.31468861589E-05 4.40240023987E-05 4.49111935640E-05 4.58239646037E-05 4.67461209614E-05 4.76943757898E-05 4.86584692661E-05 4.96442339577E-05 5.07043059682E-05 5.17297736901E-05 5.27734646343E-05 5.38387930637E-05 5.49286167871E-05 5.60368180121E-05 5.71693850117E-05 5.83245258186E-05 5.95010673092E-05 6.07037921669E-05 6.19314861450E-05 6.31825429820E-05 6.44587702578E-05 6.57616392316E-05 6.70911182794E-05 6.84449581255E-05 6.98289114290E-05 7.12384540302E-05 7.26795324221E-05 7.41470565691E-05 7.56441611892E-05 7.71731200402E-05 7.87328408410E-05 8.03248314571E-05 8.19458352941E-05 8.36022671770E-05 8.52900579600E-05 8.70123694073E-05 8.87734087055E-05 9.05658264518E-05 9.23934482207E-05 9.42635885029E-05 9.61657380528E-05 9.81099316785E-05 1.00090476594E-04 1.02114791087E-04 1.04174660946E-04 1.06281105713E-04 1.08427632871E-04 1.10618386821E-04 1.12853203570E-04 1.15134430980E-04 1.17458531338E-04 1.19832770611E-04 1.22254037037E-04 1.24723501505E-04 1.27242550190E-04 1.29813525672E-04 1.32435497154E-04 1.35112421727E-04 1.37840390275E-04 1.40626683013E-04 1.43468358370E-04 1.46364507113E-04 1.49323458950E-04 1.52338219862E-04 1.55415359790E-04 1.58557045578E-04 1.61758121117E-04 1.65026862092E-04 1.68358534952E-04 1.71763662265E-04 1.75232158375E-04 1.78772806985E-04 1.82384983735E-04 1.86067738122E-04 1.89828648338E-04 1.93662780424E-04 1.97576831331E-04 2.01566321932E-04 2.05639328650E-04 2.09793511326E-04 2.14032097249E-04 2.18353276383E-04 2.22767647827E-04 2.27265318266E-04 2.31858744487E-04 2.36542237341E-04 2.41318417465E-04 2.46195925549E-04 2.51168805262E-04 2.56243032219E-04 2.61419302581E-04 2.66700413419E-04 2.72089735659E-04 2.77584354931E-04 2.83192459012E-04 2.88914734245E-04 2.94749285959E-04 3.00705957059E-04 3.06779402118E-04 3.12977218485E-04 3.19300206502E-04 3.25751529910E-04 3.32329554970E-04 3.39046121661E-04 3.45895160053E-04 3.52883522570E-04 3.60009766790E-04 3.67286755201E-04 3.74702455789E-04 3.82273348265E-04 3.89997284306E-04 3.97872574126E-04 4.05913885790E-04 4.14112366321E-04 4.22478565535E-04 4.31014362252E-04 4.39721037807E-04 4.48603143826E-04 4.57666793789E-04 4.66910434749E-04 4.76344242800E-04 4.85967400258E-04 4.95783502542E-04 5.05801552270E-04 5.16017529335E-04 5.26442231532E-04 5.37077954548E-04 5.47926359064E-04 5.58996368062E-04 5.70288787905E-04 5.81808754417E-04 5.93563963066E-04 6.05552201420E-04 6.17787163529E-04 6.30267783945E-04 6.42999578418E-04 6.55989775563E-04 6.69238632569E-04 6.82760401027E-04 6.96553238916E-04 7.10627000228E-04 7.24979359441E-04 7.39626992363E-04 7.54566506129E-04 7.69814178198E-04 7.85361081633E-04 8.01228725944E-04 8.17413366778E-04 8.33928106751E-04 8.50774493433E-04 8.67959284302E-04 8.85495494382E-04 9.03382216821E-04 9.21634641212E-04 9.40248707534E-04 9.59245941646E-04 9.78626181237E-04 9.98390222166E-04 1.01856073574E-03 1.03913729216E-03 1.06012993305E-03 1.08154763677E-03 1.10339427373E-03 1.12568479843E-03 1.14842565158E-03 1.17162674262E-03 1.19529191656E-03 1.21944115530E-03 1.24407382983E-03 1.26920521642E-03 1.29484699818E-03 1.32100422701E-03 1.34768906853E-03 1.37491428976E-03 1.40268999823E-03 1.43102663282E-03 1.45993335951E-03 1.48942749721E-03 1.51951503409E-03 1.55021028953E-03 1.58152761449E-03 1.61347527985E-03 1.64607144784E-03 1.67932279033E-03 1.71324793072E-03 1.74785896480E-03 1.78316758817E-03 1.81918766080E-03 1.85593809028E-03 1.89343249877E-03 1.93167806924E-03 1.97070348477E-03 2.01051455195E-03 2.05112841681E-03 2.09256273468E-03 2.13483410204E-03 2.17796226639E-03 2.22195987421E-03 2.26684618559E-03 2.31263818711E-03 2.35935586627E-03 2.40701905446E-03 2.45564287100E-03 2.50524909340E-03 2.55585786330E-03 2.60748804119E-03 2.66016423784E-03 2.71390211318E-03 2.76872616398E-03 2.82465653973E-03 2.88171812953E-03 2.93993031599E-03 2.99932075305E-03 3.05991051048E-03 3.12172303831E-03 3.18478730596E-03 3.24912054299E-03 3.31475702474E-03 3.38172023158E-03 3.45003082645E-03 3.51972661736E-03 3.59082895909E-03 3.66336755567E-03 3.73736901994E-03 3.81286931736E-03 3.88989234076E-03 3.96847276309E-03 4.04863945349E-03 4.13042555897E-03 4.21386342370E-03 4.29898789589E-03 4.38583038683E-03 4.47443072220E-03 4.56481810162E-03 4.65703077384E-03 4.75110512199E-03 4.84708223408E-03 4.94499936846E-03 5.04489068467E-03 5.14680158413E-03 5.25076946954E-03 5.35684100942E-03 5.46505302833E-03 5.57545053155E-03 5.68808097080E-03 5.80297875179E-03 5.92020820312E-03 6.03979903066E-03 6.16180694695E-03 6.28628008869E-03 6.41326553680E-03 6.54281890274E-03 6.67498696860E-03 6.80982684368E-03 6.94738861453E-03 7.08773091058E-03 7.23090895179E-03 7.37697383652E-03 7.52599558706E-03 7.67802225404E-03 7.83312271508E-03 7.99135434661E-03 8.15278748716E-03 8.31747339518E-03 8.48549064571E-03 8.65690135947E-03 8.83177360235E-03 9.01018212513E-03 9.19218917999E-03 9.37787219433E-03 9.56731171693E-03 9.76057112920E-03 9.95773927444E-03 1.01588859652E-02 1.03640990586E-02 1.05734549354E-02 1.07870399152E-02 1.10049402494E-02 1.12272397317E-02 1.14540320168E-02 1.16854054520E-02 1.19214476342E-02 1.21622662767E-02 1.24079415491E-02 1.26585811398E-02 1.29142821803E-02 1.31751508304E-02 1.34412878232E-02 1.37127976154E-02 1.39897968312E-02 1.42723866421E-02 1.45606839339E-02 1.48548059578E-02 1.51548721292E-02 1.54609899430E-02 1.57733000557E-02 1.60919128761E-02 1.64169596875E-02 1.67485763592E-02 1.70868881160E-02 1.74320320214E-02 1.77841498642E-02 1.81433799464E-02 1.85098603428E-02 1.88837459326E-02 1.92651863979E-02 1.96543248454E-02 2.00513251992E-02 2.04563434948E-02 2.08695432917E-02 2.12910825642E-02 2.17211905041E-02 2.21597959015E-02 2.26075720974E-02 2.30640911692E-02 2.35300539329E-02 2.40052053067E-02 2.44901632493E-02 2.49848622211E-02 2.54894739158E-02 2.60043204219E-02 2.65295918838E-02 2.70653358229E-02 2.76122306545E-02 2.81697136773E-02 2.87388802897E-02 2.93191753339E-02 2.99115071294E-02 3.05155799420E-02 3.11320131197E-02 3.17606962365E-02 3.24022291442E-02 3.30567243478E-02 3.37244339435E-02 3.44055238777E-02 3.51003305031E-02 3.58094645221E-02 3.65325256086E-02 3.72706123423E-02 3.80230547750E-02 3.87912625029E-02 3.95746335639E-02 4.03739999495E-02 4.11893766103E-02 4.20210781819E-02 4.28701058280E-02 4.37357013346E-02 4.46190831710E-02 4.55201507450E-02 4.64396619154E-02 4.73773704306E-02 4.83342536053E-02 4.93103441347E-02 5.03064653350E-02 5.13221591154E-02 5.23587550454E-02 5.34161808374E-02 5.44948746365E-02 5.55954453752E-02 5.67181828801E-02 5.78636632934E-02 5.90320750498E-02 6.02242998952E-02 6.14405977271E-02 6.26811336244E-02 6.39471210914E-02 6.52384520482E-02 6.65556214947E-02 6.79000433202E-02 6.92708853833E-02 7.06698923100E-02 7.20969020539E-02 7.35526110511E-02 7.50380719727E-02 7.65532184085E-02 7.80990995150E-02 7.96760840309E-02 8.12846271264E-02 8.29265759540E-02 8.46004013428E-02 8.63089318861E-02 8.80515674120E-02 8.98296707378E-02 9.16431779600E-02 9.34935170835E-02 9.53813453890E-02 9.73072168537E-02 9.92716610383E-02 1.01276149976E-01 1.03320890215E-01 1.05406586854E-01 1.07535262382E-01 1.09705868035E-01 1.11920622575E-01 1.14180572934E-01 1.16485430885E-01 1.18837028398E-01 1.21236223056E-01 1.23683547914E-01 1.26180461522E-01 1.28727561191E-01 1.31326202294E-01 1.33977270379E-01 1.36681875173E-01 1.39440493553E-01 1.42255481225E-01 1.45126868781E-01 1.48056274849E-01 1.51044587802E-01 1.54093303163E-01 1.57203526826E-01 1.60376419325E-01 1.63613385912E-01 1.66915308904E-01 1.70284333585E-01 1.73720814921E-01 1.77226649320E-01 1.80803638776E-01 1.84451890926E-01 1.88174655395E-01 1.91971513249E-01 1.95845743358E-01 1.99797528833E-01 2.03829127433E-01 2.07942037067E-01 2.12137703047E-01 2.16418116957E-01 2.20784516232E-01 2.25239145092E-01 2.29783540861E-01 2.34419206265E-01 2.39148589104E-01 2.43973096579E-01 2.48894834526E-01 2.53915584602E-01 2.59037798938E-01 2.64262781098E-01 2.69593262566E-01 2.75030958946E-01 2.80578214619E-01 2.86237205753E-01 2.92010053786E-01 2.97899199281E-01 3.03906830101E-01 3.10035520737E-01 3.16287448986E-01 3.22665210264E-01 3.29171425844E-01 3.35808582714E-01 3.42579174819E-01 3.49486042159E-01 3.56531940440E-01 3.63719540863E-01 3.71051669974E-01 3.78531394977E-01 3.86161404510E-01 3.93944989361E-01 4.01884962139E-01 4.09984770094E-01 4.18247123716E-01 4.26675886698E-01 4.35273821311E-01 4.44044699606E-01 4.52991741424E-01 4.62118585774E-01 4.71428900775E-01 4.80926050592E-01 4.90614054319E-01 5.00496715866E-01 5.10577710360E-01 5.20861137158E-01 5.31351010017E-01 5.42051500820E-01 5.52966687642E-01 5.64100924520E-01 5.75458560667E-01 5.87044124969E-01 5.98861921944E-01 6.10916885150E-01 6.23213432887E-01 6.35756593959E-01 6.48551208219E-01 6.61602109536E-01 6.74914733164E-01 6.88493900437E-01 7.02345140294E-01 7.16473761385E-01 7.30885300054E-01 7.45585360608E-01 7.60579586177E-01 7.75873925064E-01 7.91474222591E-01 8.07386564518E-01 8.23617135123E-01 8.40172185919E-01 8.57058157270E-01 8.74281597518E-01 8.91849102579E-01 9.09767534001E-01 9.28043743635E-01 9.46684828937E-01 9.65697964379E-01 9.85090372845E-01 1.00486971985E+00 1.02504338057E+00 1.04561925700E+00 1.06660513776E+00 1.08800913863E+00 1.10983942140E+00 1.13210428156E+00 1.15481231374E+00 1.17797211225E+00 1.20159251622E+00 1.22568252163E+00 1.25025126973E+00 1.27530809398E+00 1.30086248834E+00 1.32692415772E+00 1.35350285496E+00 1.38060874723E+00 1.40825193349E+00 1.43644290079E+00 1.46519218643E+00 1.49451061644E+00 1.52440910092E+00 1.55489894508E+00 1.58599137836E+00 1.61769809404E+00 1.65003084586E+00 1.68300160915E+00 1.71662266383E+00 1.75090636348E+00 1.78586538927E+00 1.82151263529E+00 1.85786112710E+00 1.89492425371E+00 1.93271553868E+00 1.97124873777E+00 2.01053792868E+00 2.05059727967E+00 2.09144137556E+00 2.13308491797E+00 2.17554285909E+00 2.21883048437E+00 2.26296327962E+00 2.30795690790E+00 2.35382743451E+00 2.40059109298E+00 2.44826437863E+00 2.49686404925E+00 2.54640715272E+00 2.59691100290E+00 2.64839311670E+00 2.70087136633E+00 2.75436380701E+00 2.80888884462E+00 2.86446508636E+00 2.92111144931E+00 2.97884711543E+00 3.03769151737E+00 3.09766437327E+00 3.15878570104E+00 3.22107569128E+00 3.28455494569E+00 3.34924418728E+00 3.41516451700E+00 3.48233720112E+00 3.55078386516E+00 3.62052629146E+00 3.69158659292E+00 3.76398705954E+00 3.83775031732E+00 3.91289912289E+00 3.98945651928E+00 4.06744580465E+00 4.14689041428E+00 4.22781405022E+00 4.31024061087E+00 4.39419415340E+00 4.47969894201E+00 4.56677939857E+00 4.65546009097E+00 4.74576574180E+00 4.83772119589E+00 4.93135139610E+00 5.02668139059E+00 5.12373630312E+00 5.22254129837E+00 5.32312158134E+00 5.42550236967E+00 5.52970887019E+00 5.63576620240E+00 5.74369950610E+00 5.85353372849E+00 5.96529374712E+00 6.07900423703E+00 6.19468970100E+00 6.31237436708E+00 6.43208221996E+00 6.55383688762E+00 6.67766163482E+00 6.80357931557E+00 6.93161230090E+00 7.06178243079E+00 7.19411096514E+00 7.32861851506E+00 7.46532497207E+00 7.60424945088E+00 7.74541020604E+00 7.88882455526E+00 8.03450880478E+00 8.18247817299E+00 8.33274665869E+00 8.48532699045E+00 8.64023052331E+00 8.79746709035E+00 8.95704494600E+00 9.11897060804E+00 9.28324875901E+00 9.44988211067E+00 9.61887125933E+00 9.79021455497E+00 9.96390795883E+00 1.01399448600E+01 1.03183159435E+01 1.04990090029E+01 1.06820087606E+01 1.08672966938E+01 1.10548508143E+01 1.12446455035E+01 1.14366512463E+01 1.16308344754E+01 1.18271572720E+01 1.20255771833E+01 1.22260469272E+01 1.24285141709E+01 1.26329212168E+01 1.28392047737E+01 1.30472956178E+01 1.32571183273E+01 1.34685909436E+01 1.36816246649E+01 1.38961235176E+01 1.41119839871E+01 1.43290946983E+01 1.45473360185E+01 1.47665797060E+01 1.49866885194E+01 1.52075158035E+01 1.54289051230E+01 1.56506898231E+01 1.58726926068E+01 1.60947251257E+01 1.63165875356E+01 1.65380680424E+01 1.67589424789E+01 1.69789738430E+01 1.71979118465E+01 1.74154924594E+01 1.76314374651E+01 1.78454540033E+01 1.80572341229E+01 1.82664543519E+01 1.84727752466E+01 1.86758410060E+01 1.88752790284E+01 1.90706995497E+01 1.92616952775E+01 1.94478410206E+01 1.96286934197E+01 1.98037906272E+01 1.99726520895E+01 2.01347783396E+01 2.02896508421E+01 2.04367318877E+01 2.05754645810E+01 2.07052728321E+01 2.08255614822E+01 2.09357164735E+01 2.10351051166E+01 2.11230764622E+01 2.11989617590E+01 2.12620750372E+01 2.13117138260E+01 2.13471599660E+01 2.13676806038E+01 2.13725293241E+01 2.13609474254E+01 2.13321654084E+01 2.12854046171E+01 2.12198790785E+01 2.11347975734E+01 2.10293659110E+01 2.09027894150E+01 2.07542756949E+01 2.05830376271E+01 2.03882966353E+01 2.01692862098E+01 1.99252557452E+01 1.96554746472E+01 1.93592367520E+01 1.90358650490E+01 1.86847167111E+01 1.83051884675E+01 1.78967222713E+01 1.74588112849E+01 1.69910062346E+01 1.64929220018E+01 1.59642445969E+01 1.54047383834E+01 1.48142536104E+01 1.41927342086E+01 1.35402258066E+01 1.28568840144E+01 1.21429828358E+01 1.13989232778E+01 1.06252420333E+01 9.82262021869E+00 8.99189213902E+00 8.13405393942E+00 7.25027215402E+00 6.34189199103E+00 5.41044534438E+00 4.45765835511E+00 3.48545844818E+00 2.49598072238E+00 1.49157355580E+00 4.74803248205E-01 -5.51542387131E-01 -1.58445175511E+00 -2.62068861183E+00 -3.65679289766E+00 -4.68908341062E+00 -5.71366258295E+00 -6.72642359869E+00 -7.72306009344E+00 -8.69907871323E+00 -9.64981478007E+00 -1.05704514081E+01 -1.14560422595E+01 -1.23015383398E+01 -1.31018190218E+01 -1.38517276432E+01 -1.45461119031E+01 -1.51798693057E+01 -1.57479978564E+01 -1.62456521667E+01 -1.66682050235E+01 -1.70113145040E+01 -1.72709964397E+01 -1.74437020827E+01 -1.75264005271E+01 -1.75166653057E+01 -1.74127643092E+01 -1.72137518963E+01 -1.69195616623E+01 -1.65310979742E+01 -1.60503237732E+01 -1.54803416179E+01 -1.48254641763E+01 -1.40912695042E+01 -1.32846354795E+01 -1.24137465253E+01 -1.14880643914E+01 -1.05182530736E+01 -9.51604606466E+00 -8.49404178344E+00 -7.46541042492E+00 -6.44349225765E+00 -5.44126374269E+00 -4.47064346591E+00 -3.54160479372E+00 -2.66105614591E+00 -1.83144283877E+00 -1.05275662009E+00 -3.35169824167E-01 3.07306619074E-01 8.59812985660E-01 1.30665763522E+00 1.63134308049E+00 1.81659958195E+00 1.84444773268E+00 1.69609121578E+00 1.35358844042E+00 7.84310129423E-01 9.34042353400E-02 -9.44140738031E-03 7.83490373166E-04 -2.43535300207E-04 -1.50352382887E-04 -1.68199365630E-04 -1.74554928874E-04 -1.81619329030E-04 -1.88186155070E-04 -1.94383210815E-04 -2.00206189198E-04 6 Number of nonzero Dij 1 1 9.59525296517E-01 1 2 -2.64711790879E+00 2 2 4.55137672493E+00 3 3 1.25561736448E+00 3 4 1.70238011803E+00 4 4 2.30001024705E+00 0 nqf. If not zero, Qij's inside rinner are computed using qfcoef's 1 1 0 i j (l(j)) -1.02249591351E-01 Q_int -1.71522649031E-07 -1.74987635258E-07 -1.78522618803E-07 -1.82129013704E-07 -1.85808262566E-07 -1.89561837133E-07 -1.93391238881E-07 -1.97297999621E-07 -2.01283682104E-07 -2.05349880653E-07 -2.09498221798E-07 -2.13730364927E-07 -2.18048002950E-07 -2.22452862975E-07 -2.26946707000E-07 -2.31531332619E-07 -2.36208573739E-07 -2.40980301313E-07 -2.45848424091E-07 -2.50814889381E-07 -2.55881683831E-07 -2.61050834220E-07 -2.66324408270E-07 -2.71704515477E-07 -2.77193307948E-07 -2.82792981266E-07 -2.88505775368E-07 -2.94333975441E-07 -3.00279912836E-07 -3.06345965997E-07 -3.12534561420E-07 -3.18848174617E-07 -3.25289331107E-07 -3.31860607431E-07 -3.38564632176E-07 -3.45404087032E-07 -3.52381707862E-07 -3.59500285796E-07 -3.66762668349E-07 -3.74171760559E-07 -3.81730526149E-07 -3.89441988713E-07 -3.97309232927E-07 -4.05335405779E-07 -4.13523717830E-07 -4.21877444500E-07 -4.30399927375E-07 -4.39094575545E-07 -4.47964866970E-07 -4.57014349866E-07 -4.66246644128E-07 -4.75665442779E-07 -4.85274513444E-07 -4.95077699858E-07 -5.05078923406E-07 -5.15282184687E-07 -5.25691565119E-07 -5.36311228568E-07 -5.47145423018E-07 -5.58198482262E-07 -5.69474827646E-07 -5.80978969829E-07 -5.92715510592E-07 -6.04689144677E-07 -6.16904661666E-07 -6.29366947894E-07 -6.42080988407E-07 -6.55051868956E-07 -6.68284778027E-07 -6.81785008922E-07 -6.95557961872E-07 -7.09609146199E-07 -7.23944182521E-07 -7.38568804998E-07 -7.53488863625E-07 -7.68710326575E-07 -7.84239282585E-07 -8.00081943389E-07 -8.16244646209E-07 -8.32733856281E-07 -8.49556169448E-07 -8.66718314798E-07 -8.84227157352E-07 -9.02089700810E-07 -9.20313090358E-07 -9.38904615520E-07 -9.57871713077E-07 -9.77221970040E-07 -9.96963126687E-07 -1.01710307966E-06 -1.03764988511E-06 -1.05861176194E-06 -1.07999709509E-06 -1.10181443887E-06 -1.12407252040E-06 -1.14678024310E-06 -1.16994669025E-06 -1.19358112862E-06 -1.21769301217E-06 -1.24229198585E-06 -1.26738788944E-06 -1.29299076149E-06 -1.31911084335E-06 -1.34575858324E-06 -1.37294464047E-06 -1.40067988964E-06 -1.42897542506E-06 -1.45784256514E-06 -1.48729285693E-06 -1.51733808076E-06 -1.54799025490E-06 -1.57926164043E-06 -1.61116474609E-06 -1.64371233334E-06 -1.67691742139E-06 -1.71079329249E-06 -1.74535349718E-06 -1.78061185972E-06 -1.81658248367E-06 -1.85327975745E-06 -1.89071836017E-06 -1.92891326746E-06 -1.96787975746E-06 -2.00763341694E-06 -2.04819014755E-06 -2.08956617215E-06 -2.13177804132E-06 -2.17484263997E-06 -2.21877719411E-06 -2.26359927771E-06 -2.30932681974E-06 -2.35597811138E-06 -2.40357181326E-06 -2.45212696301E-06 -2.50166298280E-06 -2.55219968715E-06 -2.60375729085E-06 -2.65635641702E-06 -2.71001810541E-06 -2.76476382077E-06 -2.82061546143E-06 -2.87759536810E-06 -2.93572633277E-06 -2.99503160786E-06 -3.05553491548E-06 -3.11726045694E-06 -3.18023292243E-06 -3.24447750088E-06 -3.31001989007E-06 -3.37688630686E-06 -3.44510349770E-06 -3.51469874936E-06 -3.58569989977E-06 -3.65813534921E-06 -3.73203407165E-06 -3.80742562635E-06 -3.88434016967E-06 -3.96280846713E-06 -4.04286190571E-06 -4.12453250643E-06 -4.20785293712E-06 -4.29285652551E-06 -4.37957727257E-06 -4.46804986606E-06 -4.55830969445E-06 -4.65039286105E-06 -4.74433619846E-06 -4.84017728331E-06 -4.93795445124E-06 -5.03770681229E-06 -5.13947426652E-06 -5.24329751994E-06 -5.34921810083E-06 -5.45727837633E-06 -5.56752156938E-06 -5.67999177600E-06 -5.79473398297E-06 -5.91179408573E-06 -6.03121890684E-06 -6.15305621463E-06 -6.27735474232E-06 -6.40416420754E-06 -6.53353533215E-06 -6.66551986261E-06 -6.80017059058E-06 -6.93754137409E-06 -7.07768715909E-06 -7.22066400135E-06 -7.36652908895E-06 -7.51534076513E-06 -7.66715855157E-06 -7.82204317227E-06 -7.98005657778E-06 -8.14126196999E-06 -8.30572382739E-06 -8.47350793088E-06 -8.64468139004E-06 -8.81931266998E-06 -8.99747161874E-06 -9.17922949517E-06 -9.36465899746E-06 -9.55383429220E-06 -9.74683104403E-06 -9.94372644589E-06 -1.01445992499E-05 -1.03495297989E-05 -1.05586000583E-05 -1.07718936494E-05 -1.09894958823E-05 -1.12114937900E-05 -1.14379761639E-05 -1.16690335882E-05 -1.19047584773E-05 -1.21452451117E-05 -1.23905896764E-05 -1.26408902990E-05 -1.28962470891E-05 -1.31567621783E-05 -1.34225397609E-05 -1.36936861356E-05 -1.39703097483E-05 -1.42525212349E-05 -1.45404334660E-05 -1.48341615918E-05 -1.51338230882E-05 -1.54395378036E-05 -1.57514280073E-05 -1.60696184376E-05 -1.63942363523E-05 -1.67254115795E-05 -1.70632765690E-05 -1.74079664459E-05 -1.77596190641E-05 -1.81183750618E-05 -1.84843779173E-05 -1.88577740068E-05 -1.92387126624E-05 -1.96273462323E-05 -2.00238301414E-05 -2.04283229533E-05 -2.08409864340E-05 -2.12619856163E-05 -2.16914888659E-05 -2.21296679486E-05 -2.25766980989E-05 -2.30327580902E-05 -2.34980303060E-05 -2.39727008131E-05 -2.44569594356E-05 -2.49509998310E-05 -2.54550195675E-05 -2.59692202030E-05 -2.64938073653E-05 -2.70289908350E-05 -2.75749846284E-05 -2.81320070837E-05 -2.87002809480E-05 -2.92800334661E-05 -2.98714964718E-05 -3.04749064799E-05 -3.10905047810E-05 -3.17185375380E-05 -3.23592558841E-05 -3.30129160235E-05 -3.36797793335E-05 -3.43601124687E-05 -3.50541874682E-05 -3.57622818633E-05 -3.64846787894E-05 -3.72216670980E-05 -3.79735414729E-05 -3.87406025476E-05 -3.95231570251E-05 -4.03215178007E-05 -4.11360040870E-05 -4.19669415410E-05 -4.28146623943E-05 -4.36795055861E-05 -4.45618168978E-05 -4.54619490917E-05 -4.63802620517E-05 -4.73171229265E-05 -4.82729062768E-05 -4.92479942244E-05 -5.02427766050E-05 -5.12576511235E-05 -5.22930235131E-05 -5.33493076967E-05 -5.44269259528E-05 -5.55263090833E-05 -5.66478965860E-05 -5.77921368296E-05 -5.89594872326E-05 -6.01504144463E-05 -6.13653945401E-05 -6.26049131924E-05 -6.38694658836E-05 -6.51595580941E-05 -6.64757055059E-05 -6.78184342082E-05 -6.91882809072E-05 -7.05857931405E-05 -7.20115294948E-05 -7.34660598292E-05 -7.49499655022E-05 -7.64638396034E-05 -7.80082871904E-05 -7.95839255294E-05 -8.11913843415E-05 -8.28313060541E-05 -8.45043460563E-05 -8.62111729607E-05 -8.79524688692E-05 -8.97289296454E-05 -9.15412651919E-05 -9.33901997323E-05 -9.52764721009E-05 -9.72008360361E-05 -9.91640604810E-05 -1.01166929890E-04 -1.03210244540E-04 -1.05294820851E-04 -1.07421491709E-04 -1.09591106800E-04 -1.11804532946E-04 -1.14062654451E-04 -1.16366373454E-04 -1.18716610286E-04 -1.21114303838E-04 -1.23560411934E-04 -1.26055911711E-04 -1.28601800011E-04 -1.31199093772E-04 -1.33848830438E-04 -1.36552068369E-04 -1.39309887262E-04 -1.42123388579E-04 -1.44993695990E-04 -1.47921955812E-04 -1.50909337470E-04 -1.53957033961E-04 -1.57066262327E-04 -1.60238264137E-04 -1.63474305985E-04 -1.66775679989E-04 -1.70143704303E-04 -1.73579723645E-04 -1.77085109828E-04 -1.80661262305E-04 -1.84309608722E-04 -1.88031605490E-04 -1.91828738359E-04 -1.95702523006E-04 -1.99654505641E-04 -2.03686263614E-04 -2.07799406047E-04 -2.11995574466E-04 -2.16276443455E-04 -2.20643721319E-04 -2.25099150760E-04 -2.29644509568E-04 -2.34281611325E-04 -2.39012306121E-04 -2.43838481291E-04 -2.48762062156E-04 -2.53785012792E-04 -2.58909336799E-04 -2.64137078099E-04 -2.69470321744E-04 -2.74911194736E-04 -2.80461866872E-04 -2.86124551601E-04 -2.91901506895E-04 -2.97795036145E-04 -3.03807489068E-04 -3.09941262633E-04 -3.16198802011E-04 -3.22582601538E-04 -3.29095205696E-04 -3.35739210119E-04 -3.42517262618E-04 -3.49432064218E-04 -3.56486370231E-04 -3.63682991330E-04 -3.71024794667E-04 -3.78514704993E-04 -3.86155705812E-04 -3.93950840555E-04 -4.01903213773E-04 -4.10015992363E-04 -4.18292406805E-04 -4.26735752438E-04 -4.35349390749E-04 -4.44136750691E-04 -4.53101330033E-04 -4.62246696728E-04 -4.71576490312E-04 -4.81094423332E-04 -4.90804282796E-04 -5.00709931657E-04 -5.10815310329E-04 -5.21124438221E-04 -5.31641415313E-04 -5.42370423755E-04 -5.53315729503E-04 -5.64481683984E-04 -5.75872725792E-04 -5.87493382419E-04 -5.99348272022E-04 -6.11442105220E-04 -6.23779686928E-04 -6.36365918227E-04 -6.49205798271E-04 -6.62304426228E-04 -6.75667003265E-04 -6.89298834560E-04 -7.03205331368E-04 -7.17392013113E-04 -7.31864509530E-04 -7.46628562845E-04 -7.61690029994E-04 -7.77054884892E-04 -7.92729220739E-04 -8.08719252371E-04 -8.25031318665E-04 -8.41671884973E-04 -8.58647545624E-04 -8.75965026452E-04 -8.93631187394E-04 -9.11653025117E-04 -9.30037675711E-04 -9.48792417425E-04 -9.67924673460E-04 -9.87442014810E-04 -1.00735216316E-03 -1.02766299383E-03 -1.04838253881E-03 -1.06951898980E-03 -1.09108070132E-03 -1.11307619395E-03 -1.13551415751E-03 -1.15840345438E-03 -1.18175312289E-03 -1.20557238073E-03 -1.22987062843E-03 -1.25465745293E-03 -1.27994263122E-03 -1.30573613399E-03 -1.33204812943E-03 -1.35888898704E-03 -1.38626928153E-03 -1.41419979680E-03 -1.44269152997E-03 -1.47175569552E-03 -1.50140372947E-03 -1.53164729366E-03 -1.56249828009E-03 -1.59396881538E-03 -1.62607126524E-03 -1.65881823906E-03 -1.69222259465E-03 -1.72629744292E-03 -1.76105615277E-03 -1.79651235600E-03 -1.83267995236E-03 -1.86957311462E-03 -1.90720629381E-03 -1.94559422449E-03 -1.98475193013E-03 -2.02469472861E-03 -2.06543823781E-03 -2.10699838125E-03 -2.14939139387E-03 -2.19263382796E-03 -2.23674255906E-03 -2.28173479208E-03 -2.32762806751E-03 -2.37444026766E-03 -2.42218962309E-03 -2.47089471910E-03 -2.52057450239E-03 -2.57124828771E-03 -2.62293576479E-03 -2.67565700525E-03 -2.72943246965E-03 -2.78428301473E-03 -2.84022990069E-03 -2.89729479863E-03 -2.95549979807E-03 -3.01486741463E-03 -3.07542059787E-03 -3.13718273911E-03 -3.20017767959E-03 -3.26442971853E-03 -3.32996362150E-03 -3.39680462883E-03 -3.46497846415E-03 -3.53451134310E-03 -3.60542998213E-03 -3.67776160749E-03 -3.75153396427E-03 -3.82677532567E-03 -3.90351450230E-03 -3.98178085176E-03 -4.06160428818E-03 -4.14301529207E-03 -4.22604492017E-03 -4.31072481552E-03 -4.39708721767E-03 -4.48516497294E-03 -4.57499154497E-03 -4.66660102524E-03 -4.76002814387E-03 -4.85530828050E-03 -4.95247747527E-03 -5.05157244003E-03 -5.15263056960E-03 -5.25568995324E-03 -5.36078938619E-03 -5.46796838140E-03 -5.57726718138E-03 -5.68872677013E-03 -5.80238888532E-03 -5.91829603047E-03 -6.03649148733E-03 -6.15701932838E-03 -6.27992442946E-03 -6.40525248248E-03 -6.53305000828E-03 -6.66336436960E-03 -6.79624378420E-03 -6.93173733800E-03 -7.06989499840E-03 -7.21076762768E-03 -7.35440699647E-03 -7.50086579737E-03 -7.65019765857E-03 -7.80245715767E-03 -7.95769983540E-03 -8.11598220960E-03 -8.27736178915E-03 -8.44189708793E-03 -8.60964763892E-03 -8.78067400826E-03 -8.95503780937E-03 -9.13280171712E-03 -9.31402948189E-03 -9.49878594381E-03 -9.68713704683E-03 -9.87914985283E-03 -1.00748925557E-02 -1.02744344955E-02 -1.04778461721E-02 -1.06851992592E-02 -1.08965666185E-02 -1.11120223128E-02 -1.13316416198E-02 -1.15555010456E-02 -1.17836783379E-02 -1.20162524988E-02 -1.22533037983E-02 -1.24949137863E-02 -1.27411653052E-02 -1.29921425022E-02 -1.32479308409E-02 -1.35086171131E-02 -1.37742894495E-02 -1.40450373309E-02 -1.43209515985E-02 -1.46021244636E-02 -1.48886495173E-02 -1.51806217394E-02 -1.54781375068E-02 -1.57812946013E-02 -1.60901922168E-02 -1.64049309660E-02 -1.67256128863E-02 -1.70523414443E-02 -1.73852215411E-02 -1.77243595150E-02 -1.80698631443E-02 -1.84218416491E-02 -1.87804056918E-02 -1.91456673764E-02 -1.95177402478E-02 -1.98967392879E-02 -2.02827809128E-02 -2.06759829667E-02 -2.10764647157E-02 -2.14843468396E-02 -2.18997514220E-02 -2.23228019397E-02 -2.27536232492E-02 -2.31923415723E-02 -2.36390844795E-02 -2.40939808716E-02 -2.45571609590E-02 -2.50287562394E-02 -2.55088994723E-02 -2.59977246525E-02 -2.64953669799E-02 -2.70019628275E-02 -2.75176497062E-02 -2.80425662275E-02 -2.85768520625E-02 -2.91206478982E-02 -2.96740953910E-02 -3.02373371160E-02 -3.08105165136E-02 -3.13937778325E-02 -3.19872660680E-02 -3.25911268977E-02 -3.32055066120E-02 -3.38305520414E-02 -3.44664104781E-02 -3.51132295945E-02 -3.57711573557E-02 -3.64403419276E-02 -3.71209315802E-02 -3.78130745845E-02 -3.85169191050E-02 -3.92326130860E-02 -3.99603041314E-02 -4.07001393796E-02 -4.14522653706E-02 -4.22168279075E-02 -4.29939719108E-02 -4.37838412651E-02 -4.45865786595E-02 -4.54023254197E-02 -4.62312213319E-02 -4.70734044600E-02 -4.79290109527E-02 -4.87981748433E-02 -4.96810278400E-02 -5.05776991068E-02 -5.14883150357E-02 -5.24129990086E-02 -5.33518711490E-02 -5.43050480638E-02 -5.52726425746E-02 -5.62547634374E-02 -5.72515150517E-02 -5.82629971581E-02 -5.92893045233E-02 -6.03305266145E-02 -6.13867472596E-02 -6.24580442963E-02 -6.35444892070E-02 -6.46461467414E-02 -6.57630745247E-02 -6.68953226527E-02 -6.80429332720E-02 -6.92059401468E-02 -7.03843682099E-02 -7.15782331000E-02 -7.27875406828E-02 -7.40122865578E-02 -7.52524555485E-02 -7.65080211780E-02 -7.77789451273E-02 -7.90651766793E-02 -8.03666521449E-02 -8.16832942740E-02 -8.30150116495E-02 -8.43616980655E-02 -8.57232318886E-02 -8.70994754029E-02 -8.84902741389E-02 -8.98954561865E-02 -9.13148314909E-02 -9.27481911342E-02 -9.41953065998E-02 -9.56559290235E-02 -9.71297884275E-02 -9.86165929421E-02 -1.00116028012E-01 -1.01627755591E-01 -1.03151413321E-01 -1.04686613703E-01 -1.06232943256E-01 -1.07789961662E-01 -1.09357200907E-01 -1.10934164415E-01 -1.12520326169E-01 -1.14115129833E-01 -1.15717987866E-01 -1.17328280640E-01 -1.18945355551E-01 -1.20568526137E-01 -1.22197071198E-01 -1.23830233922E-01 -1.25467221019E-01 -1.27107201870E-01 -1.28749307687E-01 -1.30392630691E-01 -1.32036223310E-01 -1.33679097402E-01 -1.35320223507E-01 -1.36958530126E-01 -1.38592903038E-01 -1.40222184660E-01 -1.41845173448E-01 -1.43460623347E-01 -1.45067243298E-01 -1.46663696802E-01 -1.48248601553E-01 -1.49820529144E-01 -1.51378004840E-01 -1.52919507450E-01 -1.54443469279E-01 -1.55948276186E-01 -1.57432267735E-01 -1.58893737478E-01 -1.60330933337E-01 -1.61742058134E-01 -1.63125270244E-01 -1.64478684402E-01 -1.65800372661E-01 -1.67088365513E-01 -1.68340653185E-01 -1.69555187118E-01 -1.70729881629E-01 -1.71862615784E-01 -1.72951235477E-01 -1.73993555730E-01 -1.74987363220E-01 -1.75930419047E-01 -1.76820461756E-01 -1.77655210606E-01 -1.78432369111E-01 -1.79149628863E-01 -1.79804673627E-01 -1.80395183731E-01 -1.80918840762E-01 -1.81373332554E-01 -1.81756358496E-01 -1.82065635153E-01 -1.82298902200E-01 -1.82453928688E-01 -1.82528519624E-01 -1.82520522877E-01 -1.82427836403E-01 -1.82248415793E-01 -1.81980282125E-01 -1.81621530126E-01 -1.81170336627E-01 -1.80624969307E-01 -1.79983795694E-01 -1.79245292429E-01 -1.78408054755E-01 -1.77470806212E-01 -1.76432408521E-01 -1.75291871611E-01 -1.74048363765E-01 -1.72701221850E-01 -1.71249961579E-01 -1.69694287769E-01 -1.68034104545E-01 -1.66269525424E-01 -1.64400883239E-01 -1.62428739826E-01 -1.60353895414E-01 -1.58177397645E-01 -1.55900550144E-01 -1.53524920567E-01 -1.51052348040E-01 -1.48484949899E-01 -1.45825127638E-01 -1.43075571984E-01 -1.40239266984E-01 -1.37319493020E-01 -1.34319828642E-01 -1.31244151120E-01 -1.28096635621E-01 -1.24881752897E-01 -1.21604265394E-01 -1.18269221685E-01 -1.14881949129E-01 -1.11448044680E-01 -1.07973363744E-01 -1.04464007043E-01 -1.00926305384E-01 -9.73668023194E-02 -9.37922346264E-02 -9.02095106013E-02 -8.66256861495E-02 -8.30479386835E-02 -7.94835388560E-02 -7.59398201800E-02 -7.24241466072E-02 -6.89438781650E-02 -6.55063347761E-02 -6.21187584133E-02 -5.87882737718E-02 -5.55218476711E-02 -5.23262474287E-02 -4.92079984809E-02 -4.61733415549E-02 -4.32281897303E-02 -4.03780857556E-02 -3.76281600170E-02 -3.49830895820E-02 -3.24470587666E-02 -3.00237216974E-02 -2.77161673567E-02 -2.55268876155E-02 -2.34577487680E-02 -2.15099670851E-02 -1.96840889040E-02 -1.79799757637E-02 -1.63967950771E-02 -1.49330168146E-02 -1.35864166366E-02 -1.23540858788E-02 -1.12324487459E-02 -1.02172870128E-02 -9.30377247182E-03 -8.48650729145E-03 -7.75957237405E-03 -7.11658371524E-03 -6.55075667579E-03 -6.05497798068E-03 -5.62188515968E-03 -5.24395304080E-03 -4.91358680338E-03 -4.62322099325E-03 -4.36542379915E-03 -4.13300578907E-03 -3.91913220889E-03 -3.71743785387E-03 -3.52214343768E-03 -3.32817230440E-03 -3.13126625509E-03 -2.92809919346E-03 -2.71638723248E-03 -2.49499384460E-03 -2.26402858085E-03 -2.02493782488E-03 -1.78058598525E-03 -1.53532545810E-03 -1.29505361040E-03 -1.06725493655E-03 -8.59539478367E-04 -6.74518316339E-04 -5.13065853635E-04 -3.75592123821E-04 -2.61995501985E-04 -1.71617659844E-04 -1.03201236329E-04 -5.48507084084E-05 -2.39969625946E-05 -7.36608723869E-06 -9.52930468081E-07 -1.09436445594E-16 2.45693422629E-17 -1.92799136827E-18 -1.25757834525E-17 -2.42692282225E-17 -1.53461870744E-17 -1.59502702070E-17 2.63408330635E-17 -1.88146174987E-17 1.60682569619E-17 -1.87354510086E-17 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1 2 0 i j (l(j)) 5.41022491888E-01 Q_int 9.01442723521E-07 9.19653068449E-07 9.38231286499E-07 9.57184809194E-07 9.76521218177E-07 9.96248248255E-07 1.01637379049E-06 1.03690589534E-06 1.05785277591E-06 1.07922281121E-06 1.10102454952E-06 1.12326671180E-06 1.14595819520E-06 1.16910807659E-06 1.19272561621E-06 1.21682026136E-06 1.24140165019E-06 1.26647961557E-06 1.29206418899E-06 1.31816560459E-06 1.34479430326E-06 1.37196093679E-06 1.39967637218E-06 1.42795169593E-06 1.45679821851E-06 1.48622747888E-06 1.51625124911E-06 1.54688153906E-06 1.57813060121E-06 1.61001093556E-06 1.64253529464E-06 1.67571668856E-06 1.70956839029E-06 1.74410394090E-06 1.77933715502E-06 1.81528212636E-06 1.85195323333E-06 1.88936514480E-06 1.92753282597E-06 1.96647154436E-06 2.00619687591E-06 2.04672471122E-06 2.08807126189E-06 2.13025306702E-06 2.17328699982E-06 2.21719027434E-06 2.26198045241E-06 2.30767545060E-06 2.35429354743E-06 2.40185339068E-06 2.45037400480E-06 2.49987479860E-06 2.55037557294E-06 2.60189652870E-06 2.65445827483E-06 2.70808183662E-06 2.76278866406E-06 2.81860064051E-06 2.87554009135E-06 2.93362979299E-06 2.99289298193E-06 3.05335336409E-06 3.11503512426E-06 3.17796293582E-06 3.24216197055E-06 3.30765790875E-06 3.37447694947E-06 3.44264582103E-06 3.51219179169E-06 3.58314268055E-06 3.65552686870E-06 3.72937331055E-06 3.80471154542E-06 3.88157170937E-06 3.95998454723E-06 4.03998142492E-06 4.12159434198E-06 4.20485594436E-06 4.28979953754E-06 4.37645909975E-06 4.46486929566E-06 4.55506549018E-06 4.64708376265E-06 4.74096092122E-06 4.83673451765E-06 4.93444286223E-06 5.03412503921E-06 5.13582092235E-06 5.23957119091E-06 5.34541734591E-06 5.45340172675E-06 5.56356752810E-06 5.67595881724E-06 5.79062055164E-06 5.90759859693E-06 6.02693974532E-06 6.14869173423E-06 6.27290326544E-06 6.39962402454E-06 6.52890470085E-06 6.66079700762E-06 6.79535370279E-06 6.93262861004E-06 7.07267664035E-06 7.21555381395E-06 7.36131728273E-06 7.51002535310E-06 7.66173750932E-06 7.81651443726E-06 7.97441804874E-06 8.13551150621E-06 8.29985924809E-06 8.46752701449E-06 8.63858187354E-06 8.81309224820E-06 8.99112794361E-06 9.17276017507E-06 9.35806159645E-06 9.54710632931E-06 9.73996999251E-06 9.93672973248E-06 1.01374642541E-05 1.03422538520E-05 1.05511804430E-05 1.07643275987E-05 1.09817805787E-05 1.12036263652E-05 1.14299536972E-05 1.16608531065E-05 1.18964169536E-05 1.21367394648E-05 1.23819167698E-05 1.26320469402E-05 1.28872300286E-05 1.31475681090E-05 1.34131653170E-05 1.36841278921E-05 1.39605642196E-05 1.42425848746E-05 1.45303026655E-05 1.48238326798E-05 1.51232923296E-05 1.54288013989E-05 1.57404820914E-05 1.60584590792E-05 1.63828595531E-05 1.67138132730E-05 1.70514526200E-05 1.73959126495E-05 1.77473311448E-05 1.81058486729E-05 1.84716086398E-05 1.88447573486E-05 1.92254440578E-05 1.96138210408E-05 2.00100436472E-05 2.04142703643E-05 2.08266628812E-05 2.12473861531E-05 2.16766084672E-05 2.21145015101E-05 2.25612404367E-05 2.30170039397E-05 2.34819743217E-05 2.39563375677E-05 2.44402834195E-05 2.49340054517E-05 2.54377011493E-05 2.59515719862E-05 2.64758235061E-05 2.70106654049E-05 2.75563116138E-05 2.81129803859E-05 2.86808943826E-05 2.92602807631E-05 2.98513712752E-05 3.04544023477E-05 3.10696151855E-05 3.16972558655E-05 3.23375754352E-05 3.29908300132E-05 3.36572808916E-05 3.43371946404E-05 3.50308432141E-05 3.57385040605E-05 3.64604602318E-05 3.71970004975E-05 3.79484194599E-05 3.87150176722E-05 3.94971017585E-05 4.02949845364E-05 4.11089851419E-05 4.19394291575E-05 4.27866487420E-05 4.36509827634E-05 4.45327769345E-05 4.54323839510E-05 4.63501636327E-05 4.72864830672E-05 4.82417167568E-05 4.92162467681E-05 5.02104628850E-05 5.12247627643E-05 5.22595520951E-05 5.33152447603E-05 5.43922630030E-05 5.54910375944E-05 5.66120080068E-05 5.77556225889E-05 5.89223387450E-05 6.01126231182E-05 6.13269517767E-05 6.25658104044E-05 6.38296944946E-05 6.51191095487E-05 6.64345712779E-05 6.77766058094E-05 6.91457498969E-05 7.05425511351E-05 7.19675681785E-05 7.34213709650E-05 7.49045409436E-05 7.64176713067E-05 7.79613672274E-05 7.95362461014E-05 8.11429377938E-05 8.27820848910E-05 8.44543429571E-05 8.61603807966E-05 8.79008807212E-05 8.96765388228E-05 9.14880652519E-05 9.33361845008E-05 9.52216356941E-05 9.71451728832E-05 9.91075653485E-05 1.01109597906E-04 1.03152071222E-04 1.05235802133E-04 1.07361623969E-04 1.09530386894E-04 1.11742958236E-04 1.14000222842E-04 1.16303083428E-04 1.18652460937E-04 1.21049294914E-04 1.23494543875E-04 1.25989185693E-04 1.28534217988E-04 1.31130658528E-04 1.33779545630E-04 1.36481938580E-04 1.39238918056E-04 1.42051586557E-04 1.44921068845E-04 1.47848512394E-04 1.50835087849E-04 1.53881989494E-04 1.56990435729E-04 1.60161669553E-04 1.63396959068E-04 1.66697597979E-04 1.70064906113E-04 1.73500229948E-04 1.77004943146E-04 1.80580447109E-04 1.84228171531E-04 1.87949574975E-04 1.91746145450E-04 1.95619401012E-04 1.99570890365E-04 2.03602193480E-04 2.07714922227E-04 2.11910721022E-04 2.16191267475E-04 2.20558273070E-04 2.25013483839E-04 2.29558681068E-04 2.34195681999E-04 2.38926340564E-04 2.43752548119E-04 2.48676234203E-04 2.53699367305E-04 2.58823955652E-04 2.64052048010E-04 2.69385734501E-04 2.74827147438E-04 2.80378462176E-04 2.86041897979E-04 2.91819718908E-04 2.97714234721E-04 3.03727801797E-04 3.09862824077E-04 3.16121754020E-04 3.22507093585E-04 3.29021395224E-04 3.35667262908E-04 3.42447353157E-04 3.49364376106E-04 3.56421096584E-04 3.63620335214E-04 3.70964969542E-04 3.78457935182E-04 3.86102226987E-04 3.93900900244E-04 4.01857071890E-04 4.09973921756E-04 4.18254693836E-04 4.26702697578E-04 4.35321309201E-04 4.44113973048E-04 4.53084202951E-04 4.62235583632E-04 4.71571772139E-04 4.81096499292E-04 4.90813571178E-04 5.00726870663E-04 5.10840358940E-04 5.21158077106E-04 5.31684147773E-04 5.42422776706E-04 5.53378254503E-04 5.64554958298E-04 5.75957353509E-04 5.87589995609E-04 5.99457531946E-04 6.11564703589E-04 6.23916347214E-04 6.36517397030E-04 6.49372886743E-04 6.62487951557E-04 6.75867830217E-04 6.89517867092E-04 7.03443514304E-04 7.17650333891E-04 7.32144000021E-04 7.46930301248E-04 7.62015142813E-04 7.77404548988E-04 7.93104665474E-04 8.09121761843E-04 8.25462234025E-04 8.42132606851E-04 8.59139536645E-04 8.76489813867E-04 8.94190365808E-04 9.12248259343E-04 9.30670703731E-04 9.49465053482E-04 9.68638811272E-04 9.88199630922E-04 1.00815532043E-03 1.02851384507E-03 1.04928333055E-03 1.07047206625E-03 1.09208850847E-03 1.11414128381E-03 1.13663919259E-03 1.15959121233E-03 1.18300650129E-03 1.20689440214E-03 1.23126444560E-03 1.25612635425E-03 1.28149004640E-03 1.30736563995E-03 1.33376345645E-03 1.36069402516E-03 1.38816808721E-03 1.41619659985E-03 1.44479074079E-03 1.47396191261E-03 1.50372174724E-03 1.53408211060E-03 1.56505510727E-03 1.59665308525E-03 1.62888864082E-03 1.66177462357E-03 1.69532414141E-03 1.72955056577E-03 1.76446753685E-03 1.80008896901E-03 1.83642905625E-03 1.87350227779E-03 1.91132340377E-03 1.94990750108E-03 1.98926993928E-03 2.02942639664E-03 2.07039286630E-03 2.11218566255E-03 2.15482142729E-03 2.19831713649E-03 2.24269010691E-03 2.28795800286E-03 2.33413884318E-03 2.38125100823E-03 2.42931324718E-03 2.47834468528E-03 2.52836483141E-03 2.57939358566E-03 2.63145124717E-03 2.68455852204E-03 2.73873653144E-03 2.79400681983E-03 2.85039136344E-03 2.90791257877E-03 2.96659333139E-03 3.02645694484E-03 3.08752720973E-03 3.14982839300E-03 3.21338524735E-03 3.27822302091E-03 3.34436746704E-03 3.41184485434E-03 3.48068197685E-03 3.55090616447E-03 3.62254529353E-03 3.69562779765E-03 3.77018267870E-03 3.84623951807E-03 3.92382848813E-03 4.00298036383E-03 4.08372653468E-03 4.16609901681E-03 4.25013046534E-03 4.33585418698E-03 4.42330415288E-03 4.51251501166E-03 4.60352210278E-03 4.69636147012E-03 4.79106987581E-03 4.88768481436E-03 4.98624452698E-03 5.08678801632E-03 5.18935506132E-03 5.29398623246E-03 5.40072290723E-03 5.50960728597E-03 5.62068240792E-03 5.73399216760E-03 5.84958133159E-03 5.96749555544E-03 6.08778140110E-03 6.21048635453E-03 6.33565884371E-03 6.46334825694E-03 6.59360496156E-03 6.72648032291E-03 6.86202672376E-03 7.00029758398E-03 7.14134738066E-03 7.28523166860E-03 7.43200710112E-03 7.58173145128E-03 7.73446363352E-03 7.89026372569E-03 8.04919299139E-03 8.21131390287E-03 8.37669016424E-03 8.54538673511E-03 8.71746985469E-03 8.89300706635E-03 9.07206724251E-03 9.25472061012E-03 9.44103877649E-03 9.63109475564E-03 9.82496299507E-03 1.00227194031E-02 1.02244413765E-02 1.04302078288E-02 1.06400992192E-02 1.08541975817E-02 1.10725865544E-02 1.12953514108E-02 1.15225790895E-02 1.17543582263E-02 1.19907791859E-02 1.22319340939E-02 1.24779168703E-02 1.27288232630E-02 1.29847508813E-02 1.32457992316E-02 1.35120697515E-02 1.37836658466E-02 1.40606929265E-02 1.43432584417E-02 1.46314719218E-02 1.49254450131E-02 1.52252915182E-02 1.55311274349E-02 1.58430709966E-02 1.61612427134E-02 1.64857654131E-02 1.68167642833E-02 1.71543669148E-02 1.74987033441E-02 1.78499060985E-02 1.82081102399E-02 1.85734534110E-02 1.89460758812E-02 1.93261205934E-02 1.97137332115E-02 2.01090621688E-02 2.05122587170E-02 2.09234769754E-02 2.13428739818E-02 2.17706097434E-02 2.22068472884E-02 2.26517527189E-02 2.31054952636E-02 2.35682473322E-02 2.40401845700E-02 2.45214859131E-02 2.50123336446E-02 2.55129134516E-02 2.60234144824E-02 2.65440294051E-02 2.70749544663E-02 2.76163895512E-02 2.81685382433E-02 2.87316078861E-02 2.93058096446E-02 2.98913585678E-02 3.04884736516E-02 3.10973779032E-02 3.17182984046E-02 3.23514663786E-02 3.29971172540E-02 3.36554907320E-02 3.43268308532E-02 3.50113860650E-02 3.57094092897E-02 3.64211579934E-02 3.71468942545E-02 3.78868848341E-02 3.86414012454E-02 3.94107198246E-02 4.01951218022E-02 4.09948933736E-02 4.18103257715E-02 4.26417153375E-02 4.34893635948E-02 4.43535773203E-02 4.52346686178E-02 4.61329549908E-02 4.70487594155E-02 4.79824104137E-02 4.89342421264E-02 4.99045943863E-02 5.08938127911E-02 5.19022487763E-02 5.29302596875E-02 5.39782088525E-02 5.50464656539E-02 5.61354055994E-02 5.72454103937E-02 5.83768680079E-02 5.95301727493E-02 6.07057253304E-02 6.19039329360E-02 6.31252092905E-02 6.43699747233E-02 6.56386562333E-02 6.69316875515E-02 6.82495092032E-02 6.95925685673E-02 7.09613199346E-02 7.23562245641E-02 7.37777507371E-02 7.52263738090E-02 7.67025762589E-02 7.82068477366E-02 7.97396851068E-02 8.13015924902E-02 8.28930813017E-02 8.45146702854E-02 8.61668855455E-02 8.78502605735E-02 8.95653362724E-02 9.13126609747E-02 9.30927904580E-02 9.49062879541E-02 9.67537241539E-02 9.86356772065E-02 1.00552732713E-01 1.02505483716E-01 1.04494530675E-01 1.06520481450E-01 1.08583951261E-01 1.10685562653E-01 1.12825945448E-01 1.15005736688E-01 1.17225580572E-01 1.19486128380E-01 1.21788038398E-01 1.24131975815E-01 1.26518612629E-01 1.28948627530E-01 1.31422705773E-01 1.33941539044E-01 1.36505825310E-01 1.39116268656E-01 1.41773579109E-01 1.44478472448E-01 1.47231669999E-01 1.50033898414E-01 1.52885889436E-01 1.55788379643E-01 1.58742110179E-01 1.61747826462E-01 1.64806277880E-01 1.67918217455E-01 1.71084401505E-01 1.74305589262E-01 1.77582542487E-01 1.80916025051E-01 1.84306802495E-01 1.87755641565E-01 1.91263309719E-01 1.94830574612E-01 1.98458203545E-01 2.02146962896E-01 2.05897617505E-01 2.09710930045E-01 2.13587660352E-01 2.17528564715E-01 2.21534395149E-01 2.25605898611E-01 2.29743816200E-01 2.33948882297E-01 2.38221823688E-01 2.42563358625E-01 2.46974195859E-01 2.51455033625E-01 2.56006558580E-01 2.60629444699E-01 2.65324352117E-01 2.70091925929E-01 2.74932794934E-01 2.79847570333E-01 2.84836844362E-01 2.89901188887E-01 2.95041153925E-01 3.00257266123E-01 3.05550027162E-01 3.10919912115E-01 3.16367367734E-01 3.21892810674E-01 3.27496625652E-01 3.33179163546E-01 3.38940739415E-01 3.44781630456E-01 3.50702073893E-01 3.56702264786E-01 3.62782353774E-01 3.68942444741E-01 3.75182592405E-01 3.81502799831E-01 3.87903015873E-01 3.94383132522E-01 4.00942982195E-01 4.07582334926E-01 4.14300895488E-01 4.21098300431E-01 4.27974115035E-01 4.34927830189E-01 4.41958859181E-01 4.49066534415E-01 4.56250104039E-01 4.63508728502E-01 4.70841477024E-01 4.78247323992E-01 4.85725145282E-01 4.93273714502E-01 5.00891699162E-01 5.08577656779E-01 5.16330030910E-01 5.24147147119E-01 5.32027208891E-01 5.39968293478E-01 5.47968347701E-01 5.56025183703E-01 5.64136474652E-01 5.72299750421E-01 5.80512393223E-01 5.88771633240E-01 5.97074544218E-01 6.05418039073E-01 6.13798865489E-01 6.22213601531E-01 6.30658651283E-01 6.39130240519E-01 6.47624412421E-01 6.56137023357E-01 6.64663738732E-01 6.73200028932E-01 6.81741165372E-01 6.90282216659E-01 6.98818044909E-01 7.07343302212E-01 7.15852427283E-01 7.24339642310E-01 7.32798950033E-01 7.41224131062E-01 7.49608741475E-01 7.57946110712E-01 7.66229339798E-01 7.74451299918E-01 7.82604631378E-01 7.90681742990E-01 7.98674811900E-01 8.06575783897E-01 8.14376374250E-01 8.22068069093E-01 8.29642127406E-01 8.37089583624E-01 8.44401250920E-01 8.51567725201E-01 8.58579389853E-01 8.65426421282E-01 8.72098795301E-01 8.78586294390E-01 8.84878515890E-01 8.90964881166E-01 8.96834645784E-01 9.02476910750E-01 9.07880634855E-01 9.13034648165E-01 9.17927666701E-01 9.22548308354E-01 9.26885110073E-01 9.30926546352E-01 9.34661049082E-01 9.38077028761E-01 9.41162897132E-01 9.43907091247E-01 9.46298098989E-01 9.48324486079E-01 9.49974924565E-01 9.51238222816E-01 9.52103357002E-01 9.52559504084E-01 9.52596076267E-01 9.52202756917E-01 9.51369537905E-01 9.50086758330E-01 9.48345144581E-01 9.46135851667E-01 9.43450505744E-01 9.40281247748E-01 9.36620778042E-01 9.32462401943E-01 9.27800076023E-01 9.22628455014E-01 9.16942939175E-01 9.10739721919E-01 9.04015837527E-01 8.96769208716E-01 8.88998693834E-01 8.80704133430E-01 8.71886395931E-01 8.62547422130E-01 8.52690268186E-01 8.42319146802E-01 8.31439466249E-01 8.20057866866E-01 8.08182254669E-01 7.95821831674E-01 7.82987122540E-01 7.69689997113E-01 7.55943688455E-01 7.41762805928E-01 7.27163342910E-01 7.12162678710E-01 6.96779574251E-01 6.81034161121E-01 6.64947923576E-01 6.48543673107E-01 6.31845515215E-01 6.14878808059E-01 5.97670112661E-01 5.80247134433E-01 5.62638655780E-01 5.44874459654E-01 5.26985243924E-01 5.09002526557E-01 4.90958541637E-01 4.72886126357E-01 4.54818599178E-01 4.36789629492E-01 4.18833099161E-01 4.00982956481E-01 3.83273063173E-01 3.65737035153E-01 3.48408077946E-01 3.31318817710E-01 3.14501128991E-01 2.97985960410E-01 2.81803159638E-01 2.65981299095E-01 2.50547503944E-01 2.35527284012E-01 2.20944371393E-01 2.06820565532E-01 1.93175587654E-01 1.80026946436E-01 1.67389816832E-01 1.55276933960E-01 1.43698503907E-01 1.32662133249E-01 1.22172779005E-01 1.12232720569E-01 1.02841555044E-01 9.39962171824E-02 8.56910248854E-02 7.79177509671E-02 7.06657215604E-02 6.39219411987E-02 5.76712442336E-02 5.18964718325E-02 4.65786733674E-02 4.16973305411E-02 3.72306021202E-02 3.31555866490E-02 2.94486000192E-02 2.60854642700E-02 2.30418034994E-02 2.02933422905E-02 1.78162016008E-02 1.55871866394E-02 1.35840608746E-02 1.17857999798E-02 1.01728192490E-02 8.72716780121E-03 7.43268275774E-03 6.27509651894E-03 5.24209030469E-03 4.32328725502E-03 3.51017862909E-03 2.79597699750E-03 2.17539080678E-03 1.64431531605E-03 1.19943567838E-03 8.37738878552E-04 5.54986580006E-04 3.42519568347E-04 1.90322904586E-04 8.81903824060E-05 2.59464961130E-05 -6.29151200996E-06 -1.78093804623E-05 -1.69473794615E-05 -1.07059745790E-05 -4.30419974291E-06 -6.89716277623E-07 -7.68541211871E-17 2.11482359926E-17 1.15267050074E-17 -2.57322371210E-17 -2.25988594288E-17 5.40480868676E-17 4.52526061881E-17 -5.11600512406E-18 -1.16870828259E-17 3.46288920121E-17 -4.30529805579E-17 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1 3 1 i j (l(j)) 0.00000000000E+00 Q_int -6.98897454223E-11 -7.20182047739E-11 -7.42114853491E-11 -7.64715612472E-11 -7.88004666881E-11 -8.12002978425E-11 -8.36732147192E-11 -8.62214431089E-11 -8.88472765876E-11 -9.15530785813E-11 -9.43412844928E-11 -9.72144038939E-11 -1.00175022784E-10 -1.03225805919E-10 -1.06369499206E-10 -1.09608932181E-10 -1.12947020549E-10 -1.16386768813E-10 -1.19931272976E-10 -1.23583723328E-10 -1.27347407320E-10 -1.31225712517E-10 -1.35222129653E-10 -1.39340255771E-10 -1.43583797458E-10 -1.47956574185E-10 -1.52462521743E-10 -1.57105695785E-10 -1.61890275477E-10 -1.66820567260E-10 -1.71901008724E-10 -1.77136172606E-10 -1.82530770901E-10 -1.88089659107E-10 -1.93817840593E-10 -1.99720471103E-10 -2.05802863399E-10 -2.12070492036E-10 -2.18528998298E-10 -2.25184195268E-10 -2.32042073068E-10 -2.39108804240E-10 -2.46390749314E-10 -2.53894462523E-10 -2.61626697705E-10 -2.69594414387E-10 -2.77804784040E-10 -2.86265196541E-10 -2.94983266822E-10 -3.03966841724E-10 -3.13224007058E-10 -3.22763094886E-10 -3.32592691017E-10 -3.42721642737E-10 -3.53159066774E-10 -3.63914357496E-10 -3.74997195376E-10 -3.86417555700E-10 -3.98185717544E-10 -4.10312273031E-10 -4.22808136858E-10 -4.35684556127E-10 -4.48953120462E-10 -4.62625772445E-10 -4.76714818360E-10 -4.91232939275E-10 -5.06193202453E-10 -5.21609073113E-10 -5.37494426549E-10 -5.53863560620E-10 -5.70731208622E-10 -5.88112552540E-10 -6.06023236723E-10 -6.24479381958E-10 -6.43497599981E-10 -6.63095008431E-10 -6.83289246256E-10 -7.04098489586E-10 -7.25541468097E-10 -7.47637481867E-10 -7.70406418746E-10 -7.93868772258E-10 -8.18045660047E-10 -8.42958842881E-10 -8.68630744242E-10 -8.95084470505E-10 -9.22343831739E-10 -9.50433363132E-10 -9.79378347080E-10 -1.00920483594E-09 -1.03993967547E-09 -1.07161052902E-09 -1.10424590239E-09 -1.13787516952E-09 -1.17252859892E-09 -1.20823738089E-09 -1.24503365563E-09 -1.28295054215E-09 -1.32202216808E-09 -1.36228370037E-09 -1.40377137699E-09 -1.44652253948E-09 -1.49057566662E-09 -1.53597040903E-09 -1.58274762487E-09 -1.63094941659E-09 -1.68061916888E-09 -1.73180158766E-09 -1.78454274034E-09 -1.83889009729E-09 -1.89489257456E-09 -1.95260057792E-09 -2.01206604820E-09 -2.07334250805E-09 -2.13648511014E-09 -2.20155068677E-09 -2.26859780102E-09 -2.33768679948E-09 -2.40887986657E-09 -2.48224108046E-09 -2.55783647082E-09 -2.63573407819E-09 -2.71600401522E-09 -2.79871852984E-09 -2.88395207020E-09 -2.97178135174E-09 -3.06228542620E-09 -3.15554575282E-09 -3.25164627159E-09 -3.35067347885E-09 -3.45271650511E-09 -3.55786719532E-09 -3.66622019147E-09 -3.77787301782E-09 -3.89292616865E-09 -4.01148319875E-09 -4.13365081655E-09 -4.25953898025E-09 -4.38926099672E-09 -4.52293362352E-09 -4.66067717396E-09 -4.80261562541E-09 -4.94887673089E-09 -5.09959213400E-09 -5.25489748749E-09 -5.41493257529E-09 -5.57984143832E-09 -5.74977250419E-09 -5.92487872072E-09 -6.10531769366E-09 -6.29125182850E-09 -6.48284847666E-09 -6.68028008610E-09 -6.88372435655E-09 -7.09336439944E-09 -7.30938890269E-09 -7.53199230055E-09 -7.76137494862E-09 -7.99774330412E-09 -8.24131011177E-09 -8.49229459523E-09 -8.75092265441E-09 -9.01742706883E-09 -9.29204770706E-09 -9.57503174266E-09 -9.86663387664E-09 -1.01671165667E-08 -1.04767502634E-08 -1.07958136536E-08 -1.11245939113E-08 -1.14633869563E-08 -1.18124977200E-08 -1.21722404205E-08 -1.25429388448E-08 -1.29249266407E-08 -1.33185476169E-08 -1.37241560524E-08 -1.41421170153E-08 -1.45728066915E-08 -1.50166127233E-08 -1.54739345583E-08 -1.59451838085E-08 -1.64307846215E-08 -1.69311740615E-08 -1.74468025032E-08 -1.79781340368E-08 -1.85256468859E-08 -1.90898338379E-08 -1.96712026872E-08 -2.02702766928E-08 -2.08875950485E-08 -2.15237133689E-08 -2.21792041891E-08 -2.28546574799E-08 -2.35506811789E-08 -2.42679017377E-08 -2.50069646857E-08 -2.57685352109E-08 -2.65532987587E-08 -2.73619616490E-08 -2.81952517113E-08 -2.90539189405E-08 -2.99387361712E-08 -3.08504997738E-08 -3.17900303707E-08 -3.27581735755E-08 -3.37558007532E-08 -3.47838098054E-08 -3.58431259773E-08 -3.69347026915E-08 -3.80595224052E-08 -3.92185974949E-08 -4.04129711673E-08 -4.16437183982E-08 -4.29119468998E-08 -4.42187981181E-08 -4.55654482594E-08 -4.69531093496E-08 -4.83830303246E-08 -4.98564981541E-08 -5.13748390003E-08 -5.29394194110E-08 -5.45516475499E-08 -5.62129744631E-08 -5.79248953857E-08 -5.96889510871E-08 -6.15067292578E-08 -6.33798659380E-08 -6.53100469900E-08 -6.72990096155E-08 -6.93485439189E-08 -7.14604945181E-08 -7.36367622050E-08 -7.58793056555E-08 -7.81901431925E-08 -8.05713546022E-08 -8.30250830057E-08 -8.55535367876E-08 -8.81589915833E-08 -9.08437923272E-08 -9.36103553623E-08 -9.64611706154E-08 -9.93988038372E-08 -1.02425898912E-07 -1.05545180235E-07 -1.08759455166E-07 -1.12071616556E-07 -1.15484645349E-07 -1.19001613264E-07 -1.22625685560E-07 -1.26360123886E-07 -1.30208289213E-07 -1.34173644861E-07 -1.38259759613E-07 -1.42470310929E-07 -1.46809088253E-07 -1.51279996424E-07 -1.55887059191E-07 -1.60634422831E-07 -1.65526359880E-07 -1.70567272982E-07 -1.75761698844E-07 -1.81114312324E-07 -1.86629930634E-07 -1.92313517676E-07 -1.98170188509E-07 -2.04205213948E-07 -2.10424025312E-07 -2.16832219307E-07 -2.23435563064E-07 -2.30239999328E-07 -2.37251651801E-07 -2.44476830659E-07 -2.51922038224E-07 -2.59593974816E-07 -2.67499544784E-07 -2.75645862714E-07 -2.84040259832E-07 -2.92690290601E-07 -3.01603739518E-07 -3.10788628116E-07 -3.20253222181E-07 -3.30006039192E-07 -3.40055855979E-07 -3.50411716624E-07 -3.61082940594E-07 -3.72079131129E-07 -3.83410183878E-07 -3.95086295804E-07 -4.07117974358E-07 -4.19516046928E-07 -4.32291670584E-07 -4.45456342114E-07 -4.59021908364E-07 -4.73000576897E-07 -4.87404926978E-07 -5.02247920883E-07 -5.17542915564E-07 -5.33303674667E-07 -5.49544380905E-07 -5.66279648823E-07 -5.83524537940E-07 -6.01294566299E-07 -6.19605724419E-07 -6.38474489688E-07 -6.57917841173E-07 -6.77953274902E-07 -6.98598819593E-07 -7.19873052874E-07 -7.41795117993E-07 -7.64384741033E-07 -7.87662248654E-07 -8.11648586375E-07 -8.36365337415E-07 -8.61834742097E-07 -8.88079717859E-07 -9.15123879854E-07 -9.42991562196E-07 -9.71707839841E-07 -1.00129855113E-06 -1.03179032105E-06 -1.06321058512E-06 -1.09558761414E-06 -1.12895053955E-06 -1.16332937965E-06 -1.19875506660E-06 -1.23525947419E-06 -1.27287544658E-06 -1.31163682774E-06 -1.35157849195E-06 -1.39273637511E-06 -1.43514750708E-06 -1.47885004495E-06 -1.52388330736E-06 -1.57028780984E-06 -1.61810530121E-06 -1.66737880118E-06 -1.71815263893E-06 -1.77047249305E-06 -1.82438543252E-06 -1.87993995908E-06 -1.93718605078E-06 -1.99617520695E-06 -2.05696049443E-06 -2.11959659532E-06 -2.18413985610E-06 -2.25064833825E-06 -2.31918187048E-06 -2.38980210245E-06 -2.46257256020E-06 -2.53755870322E-06 -2.61482798326E-06 -2.69444990498E-06 -2.77649608835E-06 -2.86104033306E-06 -2.94815868475E-06 -3.03792950340E-06 -3.13043353371E-06 -3.22575397759E-06 -3.32397656899E-06 -3.42518965082E-06 -3.52948425438E-06 -3.63695418110E-06 -3.74769608675E-06 -3.86180956834E-06 -3.97939725347E-06 -4.10056489256E-06 -4.22542145380E-06 -4.35407922101E-06 -4.48665389443E-06 -4.62326469465E-06 -4.76403446962E-06 -4.90908980497E-06 -5.05856113763E-06 -5.21258287294E-06 -5.37129350530E-06 -5.53483574249E-06 -5.70335663374E-06 -5.87700770173E-06 -6.05594507856E-06 -6.24032964588E-06 -6.43032717928E-06 -6.62610849697E-06 -6.82784961312E-06 -7.03573189574E-06 -7.24994222942E-06 -7.47067318294E-06 -7.69812318205E-06 -7.93249668741E-06 -8.17400437800E-06 -8.42286334004E-06 -8.67929726169E-06 -8.94353663359E-06 -9.21581895558E-06 -9.49638894957E-06 -9.78549877898E-06 -1.00834082748E-05 -1.03903851682E-05 -1.07067053312E-05 -1.10326530231E-05 -1.13685211455E-05 -1.17146115050E-05 -1.20712350834E-05 -1.24387123160E-05 -1.28173733792E-05 -1.32075584860E-05 -1.36096181904E-05 -1.40239137018E-05 -1.44508172082E-05 -1.48907122093E-05 -1.53439938602E-05 -1.58110693245E-05 -1.62923581396E-05 -1.67882925912E-05 -1.72993181009E-05 -1.78258936242E-05 -1.83684920614E-05 -1.89276006804E-05 -1.95037215528E-05 -2.00973720023E-05 -2.07090850681E-05 -2.13394099807E-05 -2.19889126532E-05 -2.26581761871E-05 -2.33478013935E-05 -2.40584073296E-05 -2.47906318521E-05 -2.55451321866E-05 -2.63225855150E-05 -2.71236895801E-05 -2.79491633082E-05 -2.87997474514E-05 -2.96762052485E-05 -3.05793231059E-05 -3.15099112995E-05 -3.24688046978E-05 -3.34568635058E-05 -3.44749740328E-05 -3.55240494819E-05 -3.66050307648E-05 -3.77188873398E-05 -3.88666180757E-05 -4.00492521420E-05 -4.12678499251E-05 -4.25235039727E-05 -4.38173399668E-05 -4.51505177250E-05 -4.65242322333E-05 -4.79397147087E-05 -4.93982336946E-05 -5.09010961888E-05 -5.24496488055E-05 -5.40452789719E-05 -5.56894161615E-05 -5.73835331634E-05 -5.91291473909E-05 -6.09278222280E-05 -6.27811684178E-05 -6.46908454913E-05 -6.66585632397E-05 -6.86860832307E-05 -7.07752203703E-05 -7.29278445112E-05 -7.51458821094E-05 -7.74313179308E-05 -7.97861968081E-05 -8.22126254511E-05 -8.47127743106E-05 -8.72888794981E-05 -8.99432447631E-05 -9.26782435290E-05 -9.54963209903E-05 -9.83999962722E-05 -1.01391864654E-04 -1.04474599862E-04 -1.07650956422E-04 -1.10923772096E-04 -1.14295970377E-04 -1.17770563069E-04 -1.21350652935E-04 -1.25039436433E-04 -1.28840206524E-04 -1.32756355569E-04 -1.36791378312E-04 -1.40948874951E-04 -1.45232554296E-04 -1.49646237024E-04 -1.54193859037E-04 -1.58879474904E-04 -1.63707261418E-04 -1.68681521256E-04 -1.73806686738E-04 -1.79087323712E-04 -1.84528135540E-04 -1.90133967208E-04 -1.95909809560E-04 -2.01860803648E-04 -2.07992245218E-04 -2.14309589322E-04 -2.20818455074E-04 -2.27524630533E-04 -2.34434077741E-04 -2.41552937903E-04 -2.48887536720E-04 -2.56444389874E-04 -2.64230208683E-04 -2.72251905912E-04 -2.80516601756E-04 -2.89031630002E-04 -2.97804544362E-04 -3.06843124999E-04 -3.16155385239E-04 -3.25749578473E-04 -3.35634205270E-04 -3.45818020687E-04 -3.56310041793E-04 -3.67119555415E-04 -3.78256126100E-04 -3.89729604312E-04 -4.01550134866E-04 -4.13728165599E-04 -4.26274456296E-04 -4.39200087871E-04 -4.52516471805E-04 -4.66235359868E-04 -4.80368854099E-04 -4.94929417092E-04 -5.09929882559E-04 -5.25383466202E-04 -5.41303776889E-04 -5.57704828154E-04 -5.74601050012E-04 -5.92007301119E-04 -6.09938881270E-04 -6.28411544244E-04 -6.47441511021E-04 -6.67045483363E-04 -6.87240657775E-04 -7.08044739860E-04 -7.29475959069E-04 -7.51553083870E-04 -7.74295437330E-04 -7.97722913132E-04 -8.21855992038E-04 -8.46715758799E-04 -8.72323919541E-04 -8.98702819615E-04 -9.25875461948E-04 -9.53865525887E-04 -9.82697386562E-04 -1.01239613477E-03 -1.04298759740E-03 -1.07449835841E-03 -1.10695578037E-03 -1.14038802657E-03 -1.17482408376E-03 -1.21029378543E-03 -1.24682783577E-03 -1.28445783421E-03 -1.32321630071E-03 -1.36313670154E-03 -1.40425347591E-03 -1.44660206320E-03 -1.49021893093E-03 -1.53514160339E-03 -1.58140869115E-03 -1.62905992115E-03 -1.67813616767E-03 -1.72867948407E-03 -1.78073313532E-03 -1.83434163133E-03 -1.88955076112E-03 -1.94640762788E-03 -2.00496068483E-03 -2.06525977203E-03 -2.12735615400E-03 -2.19130255835E-03 -2.25715321526E-03 -2.32496389795E-03 -2.39479196409E-03 -2.46669639818E-03 -2.54073785496E-03 -2.61697870376E-03 -2.69548307390E-03 -2.77631690116E-03 -2.85954797523E-03 -2.94524598827E-03 -3.03348258451E-03 -3.12433141095E-03 -3.21786816914E-03 -3.31417066810E-03 -3.41331887832E-03 -3.51539498689E-03 -3.62048345377E-03 -3.72867106920E-03 -3.84004701222E-03 -3.95470291041E-03 -4.07273290067E-03 -4.19423369127E-03 -4.31930462498E-03 -4.44804774332E-03 -4.58056785203E-03 -4.71697258764E-03 -4.85737248513E-03 -5.00188104679E-03 -5.15061481209E-03 -5.30369342868E-03 -5.46123972451E-03 -5.62337978084E-03 -5.79024300645E-03 -5.96196221271E-03 -6.13867368963E-03 -6.32051728287E-03 -6.50763647155E-03 -6.70017844693E-03 -6.89829419187E-03 -7.10213856096E-03 -7.31187036136E-03 -7.52765243415E-03 -7.74965173623E-03 -7.97803942268E-03 -8.21299092932E-03 -8.45468605569E-03 -8.70330904799E-03 -8.95904868213E-03 -9.22209834664E-03 -9.49265612537E-03 -9.77092487973E-03 -1.00571123305E-02 -1.03514311388E-02 -1.06540989864E-02 -1.09653386546E-02 -1.12853781023E-02 -1.16144505420E-02 -1.19527945148E-02 -1.23006539627E-02 -1.26582782994E-02 -1.30259224778E-02 -1.34038470552E-02 -1.37923182555E-02 -1.41916080273E-02 -1.46019940990E-02 -1.50237600290E-02 -1.54571952518E-02 -1.59025951186E-02 -1.63602609330E-02 -1.68304999802E-02 -1.73136255501E-02 -1.78099569534E-02 -1.83198195300E-02 -1.88435446491E-02 -1.93814697013E-02 -1.99339380805E-02 -2.05012991559E-02 -2.10839082337E-02 -2.16821265061E-02 -2.22963209894E-02 -2.29268644475E-02 -2.35741353023E-02 -2.42385175281E-02 -2.49204005316E-02 -2.56201790126E-02 -2.63382528089E-02 -2.70750267208E-02 -2.78309103152E-02 -2.86063177090E-02 -2.94016673289E-02 -3.02173816478E-02 -3.10538868950E-02 -3.19116127404E-02 -3.27909919498E-02 -3.36924600104E-02 -3.46164547253E-02 -3.55634157746E-02 -3.65337842417E-02 -3.75280021035E-02 -3.85465116819E-02 -3.95897550557E-02 -4.06581734299E-02 -4.17522064615E-02 -4.28722915391E-02 -4.40188630147E-02 -4.51923513847E-02 -4.63931824197E-02 -4.76217762393E-02 -4.88785463297E-02 -5.01638985037E-02 -5.14782297988E-02 -5.28219273115E-02 -5.41953669671E-02 -5.55989122205E-02 -5.70329126872E-02 -5.84977027018E-02 -5.99935998020E-02 -6.15209031349E-02 -6.30798917857E-02 -6.46708230235E-02 -6.62939304663E-02 -6.79494221587E-02 -6.96374785651E-02 -7.13582504734E-02 -7.31118568095E-02 -7.48983823609E-02 -7.67178754083E-02 -7.85703452653E-02 -8.04557597236E-02 -8.23740424064E-02 -8.43250700275E-02 -8.63086695591E-02 -8.83246153064E-02 -9.03726258939E-02 -9.24523611620E-02 -9.45634189784E-02 -9.67053319677E-02 -9.88775641606E-02 -1.01079507570E-01 -1.03310478697E-01 -1.05569714976E-01 -1.07856371156E-01 -1.10169515648E-01 -1.12508126814E-01 -1.14871089244E-01 -1.17257190002E-01 -1.19665114868E-01 -1.22093444594E-01 -1.24540651170E-01 -1.27005094136E-01 -1.29485016948E-01 -1.31978543414E-01 -1.34483674233E-01 -1.36998283638E-01 -1.39520116196E-01 -1.42046783764E-01 -1.44575762640E-01 -1.47104390939E-01 -1.49629866224E-01 -1.52149243422E-01 -1.54659433058E-01 -1.57157199854E-01 -1.59639161711E-01 -1.62101789139E-01 -1.64541405153E-01 -1.66954185692E-01 -1.69336160601E-01 -1.71683215214E-01 -1.73991092607E-01 -1.76255396531E-01 -1.78471595116E-01 -1.80635025361E-01 -1.82740898469E-01 -1.84784306089E-01 -1.86760227483E-01 -1.88663537700E-01 -1.90489016768E-01 -1.92231359975E-01 -1.93885189256E-01 -1.95445065746E-01 -1.96905503510E-01 -1.98260984497E-01 -1.99505974729E-01 -2.00634941752E-01 -2.01642373352E-01 -2.02522797543E-01 -2.03270803825E-01 -2.03881065690E-01 -2.04348364352E-01 -2.04667613672E-01 -2.04833886219E-01 -2.04842440417E-01 -2.04688748690E-01 -2.04368526520E-01 -2.03877762316E-01 -2.03212747970E-01 -2.02370109952E-01 -2.01346840800E-01 -2.00140330820E-01 -1.98748399817E-01 -1.97169328628E-01 -1.95401890246E-01 -1.93445380276E-01 -1.91299646470E-01 -1.88965117056E-01 -1.86442827567E-01 -1.83734445867E-01 -1.80842295049E-01 -1.77769373886E-01 -1.74519374491E-01 -1.71096696848E-01 -1.67506459885E-01 -1.63754508740E-01 -1.59847417895E-01 -1.55792489868E-01 -1.51597749153E-01 -1.47271931130E-01 -1.42824465696E-01 -1.38265455393E-01 -1.33605647851E-01 -1.28856402406E-01 -1.24029650806E-01 -1.19137851957E-01 -1.14193940751E-01 -1.09211271049E-01 -1.04203552983E-01 -9.91847848098E-02 -9.41691796106E-02 -8.91710872375E-02 -8.42049119547E-02 -7.92850263235E-02 -7.44256819470E-02 -6.96409177684E-02 -6.49444666852E-02 -6.03496613068E-02 -5.58693397389E-02 -5.15157523244E-02 -4.73004703092E-02 -4.32342974230E-02 -3.93271853765E-02 -3.55881542722E-02 -3.20252189045E-02 -2.86453218867E-02 -2.54542744904E-02 -2.24567060072E-02 -1.96560223564E-02 -1.70543745554E-02 -1.46526375487E-02 -1.24503997593E-02 -1.04459635756E-02 -8.63635683812E-03 -7.01735522124E-03 -5.58351524595E-03 -4.32821748898E-03 -3.24371939310E-03 -2.32121692547E-03 -1.55091418341E-03 -9.22099911718E-04 -4.23229775553E-04 -4.20131298776E-05 2.34497057126E-04 4.19812532075E-04 5.27917782336E-04 5.73179224665E-04 5.70257015988E-04 5.34020915948E-04 4.78121033360E-04 4.10649037878E-04 3.37732815491E-04 2.64739053195E-04 1.96179585348E-04 1.35620657670E-04 8.55959382543E-05 4.75241358419E-05 2.16321216389E-05 6.88449544374E-06 9.20592799111E-07 5.25611691800E-17 -1.83858859009E-17 -2.23907394847E-17 1.42379855493E-17 -2.57881402646E-17 2.33001950126E-17 2.33014367963E-17 2.59872563173E-17 2.54117168181E-17 8.36178583236E-18 -4.39739389792E-18 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1 4 1 i j (l(j)) 0.00000000000E+00 Q_int -9.49653758436E-11 -9.78575017186E-11 -1.00837705919E-10 -1.03908670829E-10 -1.07073160522E-10 -1.10334023251E-10 -1.13694194010E-10 -1.17156697178E-10 -1.20724649239E-10 -1.24401261590E-10 -1.28189843426E-10 -1.32093804726E-10 -1.36116659314E-10 -1.40262028030E-10 -1.44533641981E-10 -1.48935345907E-10 -1.53471101635E-10 -1.58144991647E-10 -1.62961222756E-10 -1.67924129893E-10 -1.73038180006E-10 -1.78307976079E-10 -1.83738261282E-10 -1.89333923233E-10 -1.95099998401E-10 -2.01041676638E-10 -2.07164305851E-10 -2.13473396814E-10 -2.19974628128E-10 -2.26673851336E-10 -2.33577096184E-10 -2.40690576051E-10 -2.48020693544E-10 -2.55574046254E-10 -2.63357432703E-10 -2.71377858455E-10 -2.79642542427E-10 -2.88158923382E-10 -2.96934666631E-10 -3.05977670923E-10 -3.15296075564E-10 -3.24898267735E-10 -3.34792890047E-10 -3.44988848316E-10 -3.55495319579E-10 -3.66321760358E-10 -3.77477915165E-10 -3.88973825279E-10 -4.00819837779E-10 -4.13026614860E-10 -4.25605143429E-10 -4.38566744994E-10 -4.51923085850E-10 -4.65686187588E-10 -4.79868437907E-10 -4.94482601769E-10 -5.09541832884E-10 -5.25059685553E-10 -5.41050126866E-10 -5.57527549273E-10 -5.74506783539E-10 -5.92003112090E-10 -6.10032282775E-10 -6.28610523029E-10 -6.47754554491E-10 -6.67481608045E-10 -6.87809439333E-10 -7.08756344736E-10 -7.30341177841E-10 -7.52583366412E-10 -7.75502929874E-10 -7.99120497333E-10 -8.23457326143E-10 -8.48535321040E-10 -8.74377053856E-10 -9.01005783835E-10 -9.28445478572E-10 -9.56720835577E-10 -9.85857304513E-10 -1.01588111010E-09 -1.04681927570E-09 -1.07869964769E-09 -1.11155092047E-09 -1.14540266230E-09 -1.18028534196E-09 -1.21623035610E-09 -1.25327005757E-09 -1.29143778449E-09 -1.33076789029E-09 -1.37129577458E-09 -1.41305791508E-09 -1.45609190040E-09 -1.50043646390E-09 -1.54613151853E-09 -1.59321819278E-09 -1.64173886766E-09 -1.69173721490E-09 -1.74325823620E-09 -1.79634830378E-09 -1.85105520208E-09 -1.90742817080E-09 -1.96551794920E-09 -2.02537682178E-09 -2.08705866532E-09 -2.15061899739E-09 -2.21611502633E-09 -2.28360570270E-09 -2.35315177237E-09 -2.42481583119E-09 -2.49866238134E-09 -2.57475788935E-09 -2.65317084597E-09 -2.73397182776E-09 -2.81723356068E-09 -2.90303098549E-09 -2.99144132524E-09 -3.08254415473E-09 -3.17642147218E-09 -3.27315777302E-09 -3.37284012590E-09 -3.47555825113E-09 -3.58140460135E-09 -3.69047444481E-09 -3.80286595108E-09 -3.91868027943E-09 -4.03802166985E-09 -4.16099753689E-09 -4.28771856634E-09 -4.41829881485E-09 -4.55285581259E-09 -4.69151066900E-09 -4.83438818187E-09 -4.98161694956E-09 -5.13332948685E-09 -5.28966234413E-09 -5.45075623035E-09 -5.61675613963E-09 -5.78781148180E-09 -5.96407621682E-09 -6.14570899343E-09 -6.33287329186E-09 -6.52573757101E-09 -6.72447542008E-09 -6.92926571480E-09 -7.14029277838E-09 -7.35774654748E-09 -7.58182274314E-09 -7.81272304688E-09 -8.05065528232E-09 -8.29583360214E-09 -8.54847868088E-09 -8.80881791352E-09 -9.07708562020E-09 -9.35352325704E-09 -9.63837963353E-09 -9.93191113641E-09 -1.02343819605E-08 -1.05460643463E-08 -1.08672388254E-08 -1.11981944726E-08 -1.15392291661E-08 -1.18906498558E-08 -1.22527728395E-08 -1.26259240476E-08 -1.30104393363E-08 -1.34066647899E-08 -1.38149570327E-08 -1.42356835493E-08 -1.46692230159E-08 -1.51159656406E-08 -1.55763135154E-08 -1.60506809771E-08 -1.65394949810E-08 -1.70431954847E-08 -1.75622358446E-08 -1.80970832230E-08 -1.86482190097E-08 -1.92161392544E-08 -1.98013551134E-08 -2.04043933099E-08 -2.10257966078E-08 -2.16661243002E-08 -2.23259527128E-08 -2.30058757228E-08 -2.37065052929E-08 -2.44284720228E-08 -2.51724257161E-08 -2.59390359654E-08 -2.67289927549E-08 -2.75430070816E-08 -2.83818115947E-08 -2.92461612554E-08 -3.01368340165E-08 -3.10546315220E-08 -3.20003798291E-08 -3.29749301512E-08 -3.39791596246E-08 -3.50139720973E-08 -3.60802989428E-08 -3.71790998983E-08 -3.83113639282E-08 -3.94781101146E-08 -4.06803885742E-08 -4.19192814032E-08 -4.31959036517E-08 -4.45114043266E-08 -4.58669674263E-08 -4.72638130057E-08 -4.87031982747E-08 -5.01864187294E-08 -5.17148093180E-08 -5.32897456424E-08 -5.49126451961E-08 -5.65849686398E-08 -5.83082211161E-08 -6.00839536041E-08 -6.19137643149E-08 -6.37993001304E-08 -6.57422580852E-08 -6.77443868936E-08 -6.98074885240E-08 -7.19334198200E-08 -7.41240941715E-08 -7.63814832372E-08 -7.87076187184E-08 -8.11045941875E-08 -8.35745669725E-08 -8.61197600981E-08 -8.87424642861E-08 -9.14450400174E-08 -9.42299196560E-08 -9.70996096380E-08 -1.00056692727E-07 -1.03103830339E-07 -1.06243764936E-07 -1.09479322496E-07 -1.12813415054E-07 -1.16249043326E-07 -1.19789299405E-07 -1.23437369546E-07 -1.27196537032E-07 -1.31070185133E-07 -1.35061800143E-07 -1.39174974523E-07 -1.43413410134E-07 -1.47780921565E-07 -1.52281439565E-07 -1.56919014586E-07 -1.61697820421E-07 -1.66622157967E-07 -1.71696459087E-07 -1.76925290604E-07 -1.82313358409E-07 -1.87865511696E-07 -1.93586747324E-07 -1.99482214314E-07 -2.05557218483E-07 -2.11817227217E-07 -2.18267874394E-07 -2.24914965448E-07 -2.31764482598E-07 -2.38822590228E-07 -2.46095640434E-07 -2.53590178742E-07 -2.61312949993E-07 -2.69270904417E-07 -2.77471203884E-07 -2.85921228347E-07 -2.94628582486E-07 -3.03601102546E-07 -3.12846863392E-07 -3.22374185772E-07 -3.32191643802E-07 -3.42308072685E-07 -3.52732576657E-07 -3.63474537178E-07 -3.74543621376E-07 -3.85949790740E-07 -3.97703310087E-07 -4.09814756795E-07 -4.22295030319E-07 -4.35155361996E-07 -4.48407325155E-07 -4.62062845523E-07 -4.76134211957E-07 -4.90634087499E-07 -5.05575520769E-07 -5.20971957705E-07 -5.36837253654E-07 -5.53185685844E-07 -5.70031966223E-07 -5.87391254697E-07 -6.05279172762E-07 -6.23711817565E-07 -6.42705776377E-07 -6.62278141522E-07 -6.82446525743E-07 -7.03229078054E-07 -7.24644500060E-07 -7.46712062783E-07 -7.69451623995E-07 -7.92883646079E-07 -8.17029214435E-07 -8.41910056450E-07 -8.67548561033E-07 -8.93967798759E-07 -9.21191542619E-07 -9.49244289398E-07 -9.78151281712E-07 -1.00793853071E-06 -1.03863283947E-06 -1.07026182709E-06 -1.10285395356E-06 -1.13643854532E-06 -1.17104582166E-06 -1.20670692189E-06 -1.24345393333E-06 -1.28131992019E-06 -1.32033895329E-06 -1.36054614068E-06 -1.40197765925E-06 -1.44467078724E-06 -1.48866393775E-06 -1.53399669329E-06 -1.58070984139E-06 -1.62884541123E-06 -1.67844671147E-06 -1.72955836919E-06 -1.78222636997E-06 -1.83649809928E-06 -1.89242238506E-06 -1.95004954163E-06 -2.00943141490E-06 -2.07062142901E-06 -2.13367463434E-06 -2.19864775699E-06 -2.26559924977E-06 -2.33458934479E-06 -2.40568010752E-06 -2.47893549265E-06 -2.55442140153E-06 -2.63220574144E-06 -2.71235848658E-06 -2.79495174098E-06 -2.88005980332E-06 -2.96775923366E-06 -3.05812892229E-06 -3.15125016056E-06 -3.24720671402E-06 -3.34608489759E-06 -3.44797365320E-06 -3.55296462965E-06 -3.66115226498E-06 -3.77263387133E-06 -3.88750972234E-06 -4.00588314325E-06 -4.12786060371E-06 -4.25355181345E-06 -4.38306982081E-06 -4.51653111428E-06 -4.65405572715E-06 -4.79576734532E-06 -4.94179341835E-06 -5.09226527399E-06 -5.24731823604E-06 -5.40709174594E-06 -5.57172948794E-06 -5.74137951817E-06 -5.91619439750E-06 -6.09633132860E-06 -6.28195229700E-06 -6.47322421659E-06 -6.67031907939E-06 -6.87341410999E-06 -7.08269192459E-06 -7.29834069495E-06 -7.52055431724E-06 -7.74953258607E-06 -7.98548137379E-06 -8.22861281522E-06 -8.47914549802E-06 -8.73730465877E-06 -9.00332238509E-06 -9.27743782386E-06 -9.55989739569E-06 -9.85095501604E-06 -1.01508723229E-05 -1.04599189115E-05 -1.07783725760E-05 -1.11065195588E-05 -1.14446548069E-05 -1.17930822366E-05 -1.21521150060E-05 -1.25220757955E-05 -1.29032970972E-05 -1.32961215131E-05 -1.37009020616E-05 -1.41180024946E-05 -1.45477976228E-05 -1.49906736521E-05 -1.54470285291E-05 -1.59172722979E-05 -1.64018274675E-05 -1.69011293897E-05 -1.74156266498E-05 -1.79457814676E-05 -1.84920701115E-05 -1.90549833251E-05 -1.96350267663E-05 -2.02327214599E-05 -2.08486042642E-05 -2.14832283511E-05 -2.21371637012E-05 -2.28109976139E-05 -2.35053352326E-05 -2.42208000860E-05 -2.49580346460E-05 -2.57177009020E-05 -2.65004809526E-05 -2.73070776161E-05 -2.81382150580E-05 -2.89946394385E-05 -2.98771195796E-05 -3.07864476515E-05 -3.17234398807E-05 -3.26889372789E-05 -3.36838063941E-05 -3.47089400846E-05 -3.57652583159E-05 -3.68537089820E-05 -3.79752687513E-05 -3.91309439386E-05 -4.03217714021E-05 -4.15488194692E-05 -4.28131888888E-05 -4.41160138129E-05 -4.54584628078E-05 -4.68417398959E-05 -4.82670856284E-05 -4.97357781908E-05 -5.12491345417E-05 -5.28085115853E-05 -5.44153073802E-05 -5.60709623835E-05 -5.77769607333E-05 -5.95348315691E-05 -6.13461503923E-05 -6.32125404673E-05 -6.51356742654E-05 -6.71172749509E-05 -6.91591179133E-05 -7.12630323444E-05 -7.34309028630E-05 -7.56646711891E-05 -7.79663378672E-05 -8.03379640425E-05 -8.27816732891E-05 -8.52996534944E-05 -8.78941587987E-05 -9.05675115940E-05 -9.33221045819E-05 -9.61604028933E-05 -9.90849462721E-05 -1.02098351324E-04 -1.05203313830E-04 -1.08402611137E-04 -1.11699104608E-04 -1.15095742155E-04 -1.18595560845E-04 -1.22201689581E-04 -1.25917351869E-04 -1.29745868658E-04 -1.33690661275E-04 -1.37755254443E-04 -1.41943279386E-04 -1.46258477029E-04 -1.50704701299E-04 -1.55285922512E-04 -1.60006230872E-04 -1.64869840066E-04 -1.69881090973E-04 -1.75044455475E-04 -1.80364540390E-04 -1.85846091512E-04 -1.91493997781E-04 -1.97313295566E-04 -2.03309173085E-04 -2.09486974948E-04 -2.15852206835E-04 -2.22410540320E-04 -2.29167817827E-04 -2.36130057740E-04 -2.43303459658E-04 -2.50694409811E-04 -2.58309486628E-04 -2.66155466476E-04 -2.74239329564E-04 -2.82568266021E-04 -2.91149682152E-04 -2.99991206877E-04 -3.09100698365E-04 -3.18486250849E-04 -3.28156201656E-04 -3.38119138432E-04 -3.48383906580E-04 -3.58959616918E-04 -3.69855653557E-04 -3.81081682011E-04 -3.92647657543E-04 -4.04563833749E-04 -4.16840771399E-04 -4.29489347527E-04 -4.42520764790E-04 -4.55946561093E-04 -4.69778619498E-04 -4.84029178413E-04 -4.98710842083E-04 -5.13836591370E-04 -5.29419794860E-04 -5.45474220274E-04 -5.62014046218E-04 -5.79053874261E-04 -5.96608741365E-04 -6.14694132666E-04 -6.33325994623E-04 -6.52520748541E-04 -6.72295304474E-04 -6.92667075531E-04 -7.13653992583E-04 -7.35274519384E-04 -7.57547668129E-04 -7.80493015436E-04 -8.04130718796E-04 -8.28481533469E-04 -8.53566829866E-04 -8.79408611410E-04 -9.06029532904E-04 -9.33452919404E-04 -9.61702785620E-04 -9.90803855859E-04 -1.02078158452E-03 -1.05166217714E-03 -1.08347261206E-03 -1.11624066264E-03 -1.14999492013E-03 -1.18476481709E-03 -1.22058065159E-03 -1.25747361189E-03 -1.29547580196E-03 -1.33462026756E-03 -1.37494102310E-03 -1.41647307922E-03 -1.45925247106E-03 -1.50331628733E-03 -1.54870270016E-03 -1.59545099570E-03 -1.64360160559E-03 -1.69319613919E-03 -1.74427741675E-03 -1.79688950333E-03 -1.85107774372E-03 -1.90688879820E-03 -1.96437067923E-03 -2.02357278913E-03 -2.08454595865E-03 -2.14734248661E-03 -2.21201618045E-03 -2.27862239794E-03 -2.34721808976E-03 -2.41786184332E-03 -2.49061392756E-03 -2.56553633887E-03 -2.64269284820E-03 -2.72214904924E-03 -2.80397240782E-03 -2.88823231247E-03 -2.97500012626E-03 -3.06434923973E-03 -3.15635512524E-03 -3.25109539244E-03 -3.34864984514E-03 -3.44910053942E-03 -3.55253184309E-03 -3.65903049648E-03 -3.76868567461E-03 -3.88158905073E-03 -3.99783486125E-03 -4.11751997203E-03 -4.24074394620E-03 -4.36760911331E-03 -4.49822063995E-03 -4.63268660187E-03 -4.77111805751E-03 -4.91362912303E-03 -5.06033704880E-03 -5.21136229739E-03 -5.36682862302E-03 -5.52686315254E-03 -5.69159646780E-03 -5.86116268961E-03 -6.03569956307E-03 -6.21534854444E-03 -6.40025488937E-03 -6.59056774266E-03 -6.78644022931E-03 -6.98802954708E-03 -7.19549706030E-03 -7.40900839510E-03 -7.62873353583E-03 -7.85484692281E-03 -8.08752755125E-03 -8.32695907131E-03 -8.57332988927E-03 -8.82683326968E-03 -9.08766743857E-03 -9.35603568738E-03 -9.63214647786E-03 -9.91621354749E-03 -1.02084560156E-02 -1.05090984901E-02 -1.08183711741E-02 -1.11365099735E-02 -1.14637566038E-02 -1.18003586978E-02 -1.21465699120E-02 -1.25026500339E-02 -1.28688650873E-02 -1.32454874377E-02 -1.36327958967E-02 -1.40310758244E-02 -1.44406192313E-02 -1.48617248776E-02 -1.52946983707E-02 -1.57398522605E-02 -1.61975061319E-02 -1.66679866940E-02 -1.71516278664E-02 -1.76487708611E-02 -1.81597642605E-02 -1.86849640908E-02 -1.92247338900E-02 -1.97794447705E-02 -2.03494754751E-02 -2.09352124271E-02 -2.15370497719E-02 -2.21553894117E-02 -2.27906410310E-02 -2.34432221130E-02 -2.41135579459E-02 -2.48020816184E-02 -2.55092340033E-02 -2.62354637293E-02 -2.69812271385E-02 -2.77469882302E-02 -2.85332185890E-02 -2.93403972968E-02 -3.01690108268E-02 -3.10195529197E-02 -3.18925244391E-02 -3.27884332061E-02 -3.37077938121E-02 -3.46511274068E-02 -3.56189614613E-02 -3.66118295050E-02 -3.76302708330E-02 -3.86748301850E-02 -3.97460573909E-02 -4.08445069844E-02 -4.19707377807E-02 -4.31253124166E-02 -4.43087968524E-02 -4.55217598319E-02 -4.67647722993E-02 -4.80384067705E-02 -4.93432366572E-02 -5.06798355399E-02 -5.20487763892E-02 -5.34506307324E-02 -5.48859677614E-02 -5.63553533822E-02 -5.78593492002E-02 -5.93985114415E-02 -6.09733898050E-02 -6.25845262438E-02 -6.42324536735E-02 -6.59176946031E-02 -6.76407596869E-02 -6.94021461935E-02 -7.12023363899E-02 -7.30417958372E-02 -7.49209715952E-02 -7.68402903329E-02 -7.88001563422E-02 -8.08009494522E-02 -8.28430228411E-02 -8.49267007429E-02 -8.70522760479E-02 -8.92200077921E-02 -9.14301185361E-02 -9.36827916297E-02 -9.59781683608E-02 -9.83163449883E-02 -1.00697369656E-01 -1.03121239187E-01 -1.05587895762E-01 -1.08097223473E-01 -1.10649044764E-01 -1.13243116744E-01 -1.15879127398E-01 -1.18556691667E-01 -1.21275347427E-01 -1.24034551357E-01 -1.26833674701E-01 -1.29671998928E-01 -1.32548711311E-01 -1.35462900401E-01 -1.38413551440E-01 -1.41399541694E-01 -1.44419635734E-01 -1.47472480664E-01 -1.50556601322E-01 -1.53670395454E-01 -1.56812128892E-01 -1.59979930741E-01 -1.63171788603E-01 -1.66385543853E-01 -1.69618886997E-01 -1.72869353126E-01 -1.76134317510E-01 -1.79410991342E-01 -1.82696417674E-01 -1.85987467581E-01 -1.89280836578E-01 -1.92573041337E-01 -1.95860416740E-01 -1.99139113313E-01 -2.02405095082E-01 -2.05654137900E-01 -2.08881828296E-01 -2.12083562893E-01 -2.15254548453E-01 -2.18389802596E-01 -2.21484155268E-01 -2.24532250989E-01 -2.27528551964E-01 -2.30467342113E-01 -2.33342732068E-01 -2.36148665220E-01 -2.38878924861E-01 -2.41527142490E-01 -2.44086807343E-01 -2.46551277207E-01 -2.48913790570E-01 -2.51167480172E-01 -2.53305387992E-01 -2.55320481733E-01 -2.57205672837E-01 -2.58953836071E-01 -2.60557830706E-01 -2.62010523316E-01 -2.63304812208E-01 -2.64433653478E-01 -2.65390088693E-01 -2.66167274169E-01 -2.66758511816E-01 -2.67157281491E-01 -2.67357274803E-01 -2.67352430285E-01 -2.67136969818E-01 -2.66705436213E-01 -2.66052731781E-01 -2.65174157752E-01 -2.64065454342E-01 -2.62722841285E-01 -2.61143058563E-01 -2.59323407126E-01 -2.57261789292E-01 -2.54956748541E-01 -2.52407508383E-01 -2.49614009954E-01 -2.46576947978E-01 -2.43297804706E-01 -2.39778881439E-01 -2.36023327227E-01 -2.32035164295E-01 -2.27819309790E-01 -2.23381593396E-01 -2.18728770375E-01 -2.13868529613E-01 -2.08809496234E-01 -2.03561228390E-01 -1.98134207829E-01 -1.92539823885E-01 -1.86790350577E-01 -1.80898916542E-01 -1.74879467551E-01 -1.68746721471E-01 -1.62516115541E-01 -1.56203745944E-01 -1.49826299712E-01 -1.43400979113E-01 -1.36945418713E-01 -1.30477595467E-01 -1.24015732236E-01 -1.17578195259E-01 -1.11183386216E-01 -1.04849629608E-01 -9.85950562852E-02 -9.24374840773E-02 -8.63942965386E-02 -8.04823209352E-02 -7.47177066667E-02 -6.91158053837E-02 -6.36910541150E-02 -5.84568627527E-02 -5.34255072666E-02 -4.86080300172E-02 -4.40141485157E-02 -3.96521739416E-02 -3.55289406629E-02 -3.16497479197E-02 -2.80183147251E-02 -2.46367489114E-02 -2.15055310996E-02 -1.86235142101E-02 -1.59879389486E-02 -1.35944655140E-02 -1.14372215707E-02 -9.50886632498E-03 -7.80067033746E-03 -6.30261049634E-03 -5.00347938172E-03 -3.89100805904E-03 -2.95200116554E-03 -2.17248299262E-03 -1.53785312425E-03 -1.03305006744E-03 -6.42721205730E-04 -3.51397320934E-04 -1.43669860355E-04 -4.36907587409E-06 8.12588741285E-05 1.27377789977E-04 1.46434111934E-04 1.46222456939E-04 1.32822870008E-04 1.11519902811E-04 8.67523579316E-05 6.20744341749E-05 4.01296139742E-05 2.26386323708E-05 1.04028593549E-05 3.32441585863E-06 4.44327526488E-07 3.95788346628E-17 1.20631807336E-17 -4.95799947181E-18 4.34208721232E-18 -8.66084888881E-18 2.94431985310E-18 -1.47345587779E-17 6.90561634081E-18 -6.89572477351E-18 -9.16794711460E-19 2.53691768595E-18 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2 2 0 i j (l(j)) -2.58826061438E+00 Q_int -4.53022760389E-06 -4.62174424048E-06 -4.71510963447E-06 -4.81036113320E-06 -4.90753683843E-06 -5.00667562168E-06 -5.10781713968E-06 -5.21100185030E-06 -5.31627102870E-06 -5.42366678386E-06 -5.53323207541E-06 -5.64501073083E-06 -5.75904746294E-06 -5.87538788784E-06 -5.99407854315E-06 -6.11516690657E-06 -6.23870141493E-06 -6.36473148354E-06 -6.49330752598E-06 -6.62448097422E-06 -6.75830429924E-06 -6.89483103200E-06 -7.03411578483E-06 -7.17621427332E-06 -7.32118333858E-06 -7.46908096999E-06 -7.61996632836E-06 -7.77389976966E-06 -7.93094286909E-06 -8.09115844577E-06 -8.25461058783E-06 -8.42136467808E-06 -8.59148742012E-06 -8.76504686506E-06 -8.94211243871E-06 -9.12275496939E-06 -9.30704671623E-06 -9.49506139808E-06 -9.68687422299E-06 -9.88256191833E-06 -1.00822027614E-05 -1.02858766110E-05 -1.04936649388E-05 -1.07056508626E-05 -1.09219191792E-05 -1.11425563985E-05 -1.13676507777E-05 -1.15972923571E-05 -1.18315729961E-05 -1.20705864095E-05 -1.23144282053E-05 -1.25631959230E-05 -1.28169890724E-05 -1.30759091735E-05 -1.33400597974E-05 -1.36095466070E-05 -1.38844774001E-05 -1.41649621521E-05 -1.44511130597E-05 -1.47430445865E-05 -1.50408735082E-05 -1.53447189595E-05 -1.56547024819E-05 -1.59709480720E-05 -1.62935822314E-05 -1.66227340171E-05 -1.69585350933E-05 -1.73011197838E-05 -1.76506251260E-05 -1.80071909257E-05 -1.83709598127E-05 -1.87420772983E-05 -1.91206918332E-05 -1.95069548669E-05 -1.99010209085E-05 -2.03030475883E-05 -2.07131957209E-05 -2.11316293694E-05 -2.15585159113E-05 -2.19940261053E-05 -2.24383341596E-05 -2.28916178016E-05 -2.33540583488E-05 -2.38258407819E-05 -2.43071538179E-05 -2.47981899866E-05 -2.52991457067E-05 -2.58102213650E-05 -2.63316213961E-05 -2.68635543647E-05 -2.74062330484E-05 -2.79598745234E-05 -2.85247002508E-05 -2.91009361655E-05 -2.96888127668E-05 -3.02885652099E-05 -3.09004334006E-05 -3.15246620909E-05 -3.21615009773E-05 -3.28112047999E-05 -3.34740334454E-05 -3.41502520500E-05 -3.48401311061E-05 -3.55439465702E-05 -3.62619799734E-05 -3.69945185341E-05 -3.77418552726E-05 -3.85042891287E-05 -3.92821250806E-05 -4.00756742679E-05 -4.08852541151E-05 -4.17111884590E-05 -4.25538076783E-05 -4.34134488255E-05 -4.42904557619E-05 -4.51851792951E-05 -4.60979773192E-05 -4.70292149581E-05 -4.79792647116E-05 -4.89485066040E-05 -4.99373283367E-05 -5.09461254427E-05 -5.19753014452E-05 -5.30252680188E-05 -5.40964451543E-05 -5.51892613264E-05 -5.63041536655E-05 -5.74415681323E-05 -5.86019596960E-05 -5.97857925167E-05 -6.09935401307E-05 -6.22256856402E-05 -6.34827219060E-05 -6.47651517452E-05 -6.60734881322E-05 -6.74082544036E-05 -6.87699844677E-05 -7.01592230179E-05 -7.15765257510E-05 -7.30224595890E-05 -7.44976029057E-05 -7.60025457588E-05 -7.75378901250E-05 -7.91042501415E-05 -8.07022523511E-05 -8.23325359531E-05 -8.39957530588E-05 -8.56925689523E-05 -8.74236623569E-05 -8.91897257061E-05 -9.09914654207E-05 -9.28296021915E-05 -9.47048712674E-05 -9.66180227496E-05 -9.85698218911E-05 -1.00561049404E-04 -1.02592501769E-04 -1.04664991558E-04 -1.06779347756E-04 -1.08936416094E-04 -1.11137059385E-04 -1.13382157873E-04 -1.15672609582E-04 -1.18009330676E-04 -1.20393255826E-04 -1.22825338582E-04 -1.25306551758E-04 -1.27837887815E-04 -1.30420359265E-04 -1.33054999071E-04 -1.35742861062E-04 -1.38485020353E-04 -1.41282573777E-04 -1.44136640323E-04 -1.47048361581E-04 -1.50018902205E-04 -1.53049450369E-04 -1.56141218251E-04 -1.59295442514E-04 -1.62513384801E-04 -1.65796332238E-04 -1.69145597950E-04 -1.72562521589E-04 -1.76048469865E-04 -1.79604837094E-04 -1.83233045757E-04 -1.86934547067E-04 -1.90710821553E-04 -1.94563379645E-04 -1.98493762285E-04 -2.02503541540E-04 -2.06594321231E-04 -2.10767737573E-04 -2.15025459834E-04 -2.19369190995E-04 -2.23800668438E-04 -2.28321664636E-04 -2.32933987865E-04 -2.37639482925E-04 -2.42440031878E-04 -2.47337554799E-04 -2.52334010549E-04 -2.57431397553E-04 -2.62631754599E-04 -2.67937161657E-04 -2.73349740709E-04 -2.78871656594E-04 -2.84505117880E-04 -2.90252377740E-04 -2.96115734860E-04 -3.02097534351E-04 -3.08200168691E-04 -3.14426078682E-04 -3.20777754422E-04 -3.27257736305E-04 -3.33868616033E-04 -3.40613037652E-04 -3.47493698615E-04 -3.54513350850E-04 -3.61674801872E-04 -3.68980915895E-04 -3.76434614983E-04 -3.84038880216E-04 -3.91796752884E-04 -3.99711335697E-04 -4.07785794032E-04 -4.16023357196E-04 -4.24427319714E-04 -4.33001042648E-04 -4.41747954943E-04 -4.50671554794E-04 -4.59775411044E-04 -4.69063164614E-04 -4.78538529953E-04 -4.88205296529E-04 -4.98067330338E-04 -5.08128575453E-04 -5.18393055596E-04 -5.28864875751E-04 -5.39548223801E-04 -5.50447372203E-04 -5.61566679695E-04 -5.72910593038E-04 -5.84483648795E-04 -5.96290475138E-04 -6.08335793706E-04 -6.20624421482E-04 -6.33161272727E-04 -6.45951360937E-04 -6.58999800850E-04 -6.72311810486E-04 -6.85892713236E-04 -6.99747939987E-04 -7.13883031291E-04 -7.28303639578E-04 -7.43015531418E-04 -7.58024589820E-04 -7.73336816586E-04 -7.88958334706E-04 -8.04895390803E-04 -8.21154357633E-04 -8.37741736626E-04 -8.54664160485E-04 -8.71928395833E-04 -8.89541345920E-04 -9.07510053376E-04 -9.25841703023E-04 -9.44543624749E-04 -9.63623296433E-04 -9.83088346929E-04 -1.00294655911E-03 -1.02320587300E-03 -1.04387438889E-03 -1.06496037065E-03 -1.08647224894E-03 -1.10841862465E-03 -1.13080827230E-03 -1.15365014356E-03 -1.17695337077E-03 -1.20072727068E-03 -1.22498134809E-03 -1.24972529966E-03 -1.27496901782E-03 -1.30072259465E-03 -1.32699632599E-03 -1.35380071548E-03 -1.38114647878E-03 -1.40904454784E-03 -1.43750607528E-03 -1.46654243882E-03 -1.49616524581E-03 -1.52638633790E-03 -1.55721779572E-03 -1.58867194374E-03 -1.62076135515E-03 -1.65349885689E-03 -1.68689753479E-03 -1.72097073873E-03 -1.75573208804E-03 -1.79119547686E-03 -1.82737507974E-03 -1.86428535724E-03 -1.90194106172E-03 -1.94035724325E-03 -1.97954925556E-03 -2.01953276218E-03 -2.06032374269E-03 -2.10193849908E-03 -2.14439366227E-03 -2.18770619870E-03 -2.23189341711E-03 -2.27697297545E-03 -2.32296288789E-03 -2.36988153203E-03 -2.41774765616E-03 -2.46658038682E-03 -2.51639923631E-03 -2.56722411057E-03 -2.61907531703E-03 -2.67197357270E-03 -2.72594001247E-03 -2.78099619748E-03 -2.83716412371E-03 -2.89446623076E-03 -2.95292541073E-03 -3.01256501740E-03 -3.07340887544E-03 -3.13548128998E-03 -3.19880705619E-03 -3.26341146922E-03 -3.32932033420E-03 -3.39655997654E-03 -3.46515725239E-03 -3.53513955931E-03 -3.60653484716E-03 -3.67937162923E-03 -3.75367899356E-03 -3.82948661448E-03 -3.90682476443E-03 -3.98572432598E-03 -4.06621680409E-03 -4.14833433862E-03 -4.23210971711E-03 -4.31757638778E-03 -4.40476847282E-03 -4.49372078194E-03 -4.58446882617E-03 -4.67704883194E-03 -4.77149775551E-03 -4.86785329756E-03 -4.96615391818E-03 -5.06643885211E-03 -5.16874812432E-03 -5.27312256584E-03 -5.37960382995E-03 -5.48823440871E-03 -5.59905764979E-03 -5.71211777359E-03 -5.82745989082E-03 -5.94513002033E-03 -6.06517510733E-03 -6.18764304195E-03 -6.31258267824E-03 -6.44004385343E-03 -6.57007740772E-03 -6.70273520429E-03 -6.83807014989E-03 -6.97613621572E-03 -7.11698845870E-03 -7.26068304333E-03 -7.40727726378E-03 -7.55682956654E-03 -7.70939957351E-03 -7.86504810550E-03 -8.02383720624E-03 -8.18583016684E-03 -8.35109155077E-03 -8.51968721928E-03 -8.69168435737E-03 -8.86715150023E-03 -9.04615856028E-03 -9.22877685466E-03 -9.41507913328E-03 -9.60513960748E-03 -9.79903397920E-03 -9.99683947075E-03 -1.01986348551E-02 -1.04045004871E-02 -1.06145183344E-02 -1.08287720104E-02 -1.10473468067E-02 -1.12703297264E-02 -1.14978095184E-02 -1.17298767124E-02 -1.19666236539E-02 -1.22081445406E-02 -1.24545354595E-02 -1.27058944241E-02 -1.29623214130E-02 -1.32239184088E-02 -1.34907894382E-02 -1.37630406124E-02 -1.40407801685E-02 -1.43241185121E-02 -1.46131682598E-02 -1.49080442836E-02 -1.52088637552E-02 -1.55157461922E-02 -1.58288135040E-02 -1.61481900394E-02 -1.64740026354E-02 -1.68063806656E-02 -1.71454560913E-02 -1.74913635120E-02 -1.78442402181E-02 -1.82042262440E-02 -1.85714644218E-02 -1.89461004373E-02 -1.93282828861E-02 -1.97181633308E-02 -2.01158963597E-02 -2.05216396465E-02 -2.09355540109E-02 -2.13578034808E-02 -2.17885553555E-02 -2.22279802697E-02 -2.26762522593E-02 -2.31335488284E-02 -2.36000510171E-02 -2.40759434713E-02 -2.45614145130E-02 -2.50566562127E-02 -2.55618644626E-02 -2.60772390517E-02 -2.66029837419E-02 -2.71393063457E-02 -2.76864188055E-02 -2.82445372737E-02 -2.88138821958E-02 -2.93946783932E-02 -2.99871551490E-02 -3.05915462949E-02 -3.12080902991E-02 -3.18370303572E-02 -3.24786144836E-02 -3.31330956051E-02 -3.38007316562E-02 -3.44817856758E-02 -3.51765259068E-02 -3.58852258959E-02 -3.66081645964E-02 -3.73456264727E-02 -3.80979016066E-02 -3.88652858052E-02 -3.96480807112E-02 -4.04465939154E-02 -4.12611390708E-02 -4.20920360084E-02 -4.29396108565E-02 -4.38041961604E-02 -4.46861310057E-02 -4.55857611429E-02 -4.65034391144E-02 -4.74395243844E-02 -4.83943834700E-02 -4.93683900755E-02 -5.03619252290E-02 -5.13753774206E-02 -5.24091427443E-02 -5.34636250411E-02 -5.45392360455E-02 -5.56363955341E-02 -5.67555314772E-02 -5.78970801920E-02 -5.90614864999E-02 -6.02492038852E-02 -6.14606946572E-02 -6.26964301149E-02 -6.39568907144E-02 -6.52425662388E-02 -6.65539559720E-02 -6.78915688740E-02 -6.92559237601E-02 -7.06475494825E-02 -7.20669851155E-02 -7.35147801428E-02 -7.49914946486E-02 -7.64976995115E-02 -7.80339766016E-02 -7.96009189804E-02 -8.11991311043E-02 -8.28292290309E-02 -8.44918406290E-02 -8.61876057915E-02 -8.79171766512E-02 -8.96812178009E-02 -9.14804065160E-02 -9.33154329806E-02 -9.51870005170E-02 -9.70958258190E-02 -9.90426391878E-02 -1.01028184772E-01 -1.03053220811E-01 -1.05118519880E-01 -1.07224869143E-01 -1.09373070604E-01 -1.11563941366E-01 -1.13798313887E-01 -1.16077036251E-01 -1.18400972429E-01 -1.20771002555E-01 -1.23188023195E-01 -1.25652947631E-01 -1.28166706137E-01 -1.30730246268E-01 -1.33344533143E-01 -1.36010549743E-01 -1.38729297201E-01 -1.41501795102E-01 -1.44329081784E-01 -1.47212214644E-01 -1.50152270444E-01 -1.53150345625E-01 -1.56207556618E-01 -1.59325040163E-01 -1.62503953632E-01 -1.65745475345E-01 -1.69050804904E-01 -1.72421163515E-01 -1.75857794325E-01 -1.79361962752E-01 -1.82934956823E-01 -1.86578087511E-01 -1.90292689079E-01 -1.94080119418E-01 -1.97941760397E-01 -2.01879018206E-01 -2.05893323702E-01 -2.09986132765E-01 -2.14158926641E-01 -2.18413212301E-01 -2.22750522785E-01 -2.27172417562E-01 -2.31680482879E-01 -2.36276332115E-01 -2.40961606137E-01 -2.45737973645E-01 -2.50607131534E-01 -2.55570805233E-01 -2.60630749065E-01 -2.65788746586E-01 -2.71046610935E-01 -2.76406185171E-01 -2.81869342619E-01 -2.87437987203E-01 -2.93114053775E-01 -2.98899508448E-01 -3.04796348915E-01 -3.10806604767E-01 -3.16932337807E-01 -3.23175642351E-01 -3.29538645528E-01 -3.36023507568E-01 -3.42632422088E-01 -3.49367616356E-01 -3.56231351562E-01 -3.63225923064E-01 -3.70353660628E-01 -3.77616928661E-01 -3.85018126419E-01 -3.92559688210E-01 -4.00244083581E-01 -4.08073817486E-01 -4.16051430435E-01 -4.24179498632E-01 -4.32460634091E-01 -4.40897484721E-01 -4.49492734409E-01 -4.58249103063E-01 -4.67169346636E-01 -4.76256257128E-01 -4.85512662557E-01 -4.94941426901E-01 -5.04545450010E-01 -5.14327667490E-01 -5.24291050545E-01 -5.34438605793E-01 -5.44773375037E-01 -5.55298435004E-01 -5.66016897036E-01 -5.76931906742E-01 -5.88046643603E-01 -5.99364320534E-01 -6.10888183386E-01 -6.22621510408E-01 -6.34567611647E-01 -6.46729828292E-01 -6.59111531959E-01 -6.71716123916E-01 -6.84547034236E-01 -6.97607720889E-01 -7.10901668761E-01 -7.24432388592E-01 -7.38203415851E-01 -7.52218309511E-01 -7.66480650759E-01 -7.80994041603E-01 -7.95762103397E-01 -8.10788475266E-01 -8.26076812436E-01 -8.41630784452E-01 -8.57454073306E-01 -8.73550371431E-01 -8.89923379599E-01 -9.06576804691E-01 -9.23514357336E-01 -9.40739749434E-01 -9.58256691531E-01 -9.76068890066E-01 -9.94180044465E-01 -1.01259384409E+00 -1.03131396504E+00 -1.05034406675E+00 -1.06968778853E+00 -1.08934874576E+00 -1.10933052610E+00 -1.12963668537E+00 -1.15027074330E+00 -1.17123617910E+00 -1.19253642679E+00 -1.21417487034E+00 -1.23615483860E+00 -1.25847959999E+00 -1.28115235698E+00 -1.30417624033E+00 -1.32755430311E+00 -1.35128951439E+00 -1.37538475280E+00 -1.39984279971E+00 -1.42466633224E+00 -1.44985791590E+00 -1.47541999703E+00 -1.50135489488E+00 -1.52766479345E+00 -1.55435173301E+00 -1.58141760126E+00 -1.60886412427E+00 -1.63669285697E+00 -1.66490517346E+00 -1.69350225684E+00 -1.72248508879E+00 -1.75185443876E+00 -1.78161085282E+00 -1.81175464217E+00 -1.84228587120E+00 -1.87320434534E+00 -1.90450959836E+00 -1.93620087941E+00 -1.96827713966E+00 -2.00073701851E+00 -2.03357882949E+00 -2.06680054569E+00 -2.10039978489E+00 -2.13437379425E+00 -2.16871943464E+00 -2.20343316453E+00 -2.23851102365E+00 -2.27394861607E+00 -2.30974109310E+00 -2.34588313569E+00 -2.38236893658E+00 -2.41919218204E+00 -2.45634603328E+00 -2.49382310761E+00 -2.53161545920E+00 -2.56971455962E+00 -2.60811127810E+00 -2.64679586151E+00 -2.68575791415E+00 -2.72498637734E+00 -2.76446950883E+00 -2.80419486205E+00 -2.84414926533E+00 -2.88431880091E+00 -2.92468878411E+00 -2.96524374235E+00 -3.00596739431E+00 -3.04684262921E+00 -3.08785148620E+00 -3.12897513404E+00 -3.17019385102E+00 -3.21148700525E+00 -3.25283303538E+00 -3.29420943179E+00 -3.33559271841E+00 -3.37695843516E+00 -3.41828112113E+00 -3.45953429870E+00 -3.50069045849E+00 -3.54172104547E+00 -3.58259644617E+00 -3.62328597719E+00 -3.66375787516E+00 -3.70397928816E+00 -3.74391626891E+00 -3.78353376966E+00 -3.82279563913E+00 -3.86166462152E+00 -3.90010235777E+00 -3.93806938930E+00 -3.97552516431E+00 -4.01242804686E+00 -4.04873532893E+00 -4.08440324556E+00 -4.11938699338E+00 -4.15364075263E+00 -4.18711771286E+00 -4.21977010264E+00 -4.25154922323E+00 -4.28240548673E+00 -4.31228845866E+00 -4.34114690527E+00 -4.36892884585E+00 -4.39558161004E+00 -4.42105190065E+00 -4.44528586183E+00 -4.46822915310E+00 -4.48982702919E+00 -4.51002442600E+00 -4.52876605276E+00 -4.54599649061E+00 -4.56166029770E+00 -4.57570212092E+00 -4.58806681440E+00 -4.59869956480E+00 -4.60754602355E+00 -4.61455244592E+00 -4.61966583711E+00 -4.62283410518E+00 -4.62400622077E+00 -4.62313238362E+00 -4.62016419565E+00 -4.61505484039E+00 -4.60775926865E+00 -4.59823438997E+00 -4.58643926974E+00 -4.57233533129E+00 -4.55588656283E+00 -4.53705972841E+00 -4.51582458253E+00 -4.49215408767E+00 -4.46602463389E+00 -4.43741625997E+00 -4.40631287486E+00 -4.37270247876E+00 -4.33657738266E+00 -4.29793442520E+00 -4.25677518572E+00 -4.21310619208E+00 -4.16693912208E+00 -4.11829099682E+00 -4.06718436467E+00 -4.01364747404E+00 -3.95771443353E+00 -3.89942535758E+00 -3.83882649586E+00 -3.77597034465E+00 -3.71091573826E+00 -3.64372791874E+00 -3.57447858183E+00 -3.50324589743E+00 -3.43011450252E+00 -3.35517546498E+00 -3.27852621624E+00 -3.20027045122E+00 -3.12051799402E+00 -3.03938462764E+00 -2.95699188673E+00 -2.87346681189E+00 -2.78894166481E+00 -2.70355360333E+00 -2.61744431614E+00 -2.53075961672E+00 -2.44364899684E+00 -2.35626513998E+00 -2.26876339552E+00 -2.18130121497E+00 -2.09403755187E+00 -2.00713222750E+00 -1.92074526484E+00 -1.83503619400E+00 -1.75016333244E+00 -1.66628304415E+00 -1.58354898218E+00 -1.50211131955E+00 -1.42211597396E+00 -1.34370383230E+00 -1.26700998108E+00 -1.19216294968E+00 -1.11928397331E+00 -1.04848628305E+00 -9.79874430418E-01 -9.13543654144E-01 -8.49579296771E-01 -7.88056278724E-01 -7.29038637278E-01 -6.72579137589E-01 -6.18718962576E-01 -5.67487487867E-01 -5.18902147426E-01 -4.72968394643E-01 -4.29679762771E-01 -3.89018027536E-01 -3.50953473566E-01 -3.15445265007E-01 -2.82441919273E-01 -2.51881881409E-01 -2.23694194963E-01 -1.97799263683E-01 -1.74109696675E-01 -1.52531228057E-01 -1.32963700523E-01 -1.15302100705E-01 -9.94376327807E-02 -8.52588155184E-02 -7.26525868036E-02 -6.15053988649E-02 -5.17042867776E-02 -4.31378925397E-02 -3.56974270568E-02 -2.92775528145E-02 -2.37771708704E-02 -1.91000971067E-02 -1.51556144767E-02 -1.18588902624E-02 -9.13125016977E-03 -6.90030441228E-03 -5.09992478526E-03 -3.67007609903E-03 -2.55651019624E-03 -1.71033610153E-03 -1.08748559063E-03 -6.48099563756E-04 -3.55269165611E-04 -1.73297916088E-04 -7.05785852618E-05 -2.06480126539E-05 -2.37958523250E-06 -5.79763238213E-10 -2.89366804682E-06 -5.13791836167E-06 -4.74071817806E-06 -2.50828230788E-06 -4.98905607452E-07 -2.26418735492E-17 -1.80715578911E-17 -9.90646575890E-18 -1.88078552927E-17 -4.22530464219E-17 1.58313205358E-19 2.40004216649E-17 -2.73678452758E-17 -7.72099330357E-17 -2.28315158130E-17 6.64563239175E-17 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2 3 1 i j (l(j)) 0.00000000000E+00 Q_int 1.78155010087E-10 1.83580637445E-10 1.89171499732E-10 1.94932629101E-10 2.00869210954E-10 2.06986588614E-10 2.13290268132E-10 2.19785923243E-10 2.26479400472E-10 2.33376724397E-10 2.40484103075E-10 2.47807933622E-10 2.55354807977E-10 2.63131518833E-10 2.71145065753E-10 2.79402661466E-10 2.87911738362E-10 2.96679955181E-10 3.05715203905E-10 3.15025616865E-10 3.24619574056E-10 3.34505710684E-10 3.44692924932E-10 3.55190385978E-10 3.66007542239E-10 3.77154129880E-10 3.88640181577E-10 4.00476035545E-10 4.12672344846E-10 4.25240086974E-10 4.38190573740E-10 4.51535461446E-10 4.65286761386E-10 4.79456850649E-10 4.94058483263E-10 5.09104801674E-10 5.24609348575E-10 5.40586079094E-10 5.57049373357E-10 5.74014049429E-10 5.91495376651E-10 6.09509089386E-10 6.28071401178E-10 6.47199019347E-10 6.66909160026E-10 6.87219563657E-10 7.08148510959E-10 7.29714839380E-10 7.51937960054E-10 7.74837875271E-10 7.98435196482E-10 8.22751162847E-10 8.47807660357E-10 8.73627241529E-10 9.00233145704E-10 9.27649319967E-10 9.55900440699E-10 9.85011935790E-10 1.01501000752E-09 1.04592165615E-09 1.07777470421E-09 1.11059782158E-09 1.14442055122E-09 1.17927333585E-09 1.21518754529E-09 1.25219550470E-09 1.29033052371E-09 1.32962692635E-09 1.37012008201E-09 1.41184643720E-09 1.45484354841E-09 1.49915011587E-09 1.54480601844E-09 1.59185234946E-09 1.64033145372E-09 1.69028696562E-09 1.74176384844E-09 1.79480843475E-09 1.84946846820E-09 1.90579314642E-09 1.96383316534E-09 2.02364076479E-09 2.08526977556E-09 2.14877566782E-09 2.21421560105E-09 2.28164847550E-09 2.35113498519E-09 2.42273767254E-09 2.49652098468E-09 2.57255133144E-09 2.65089714510E-09 2.73162894205E-09 2.81481938620E-09 2.90054335438E-09 2.98887800379E-09 3.07990284138E-09 3.17369979547E-09 3.27035328943E-09 3.36995031773E-09 3.47258052419E-09 3.57833628268E-09 3.68731278028E-09 3.79960810293E-09 3.91532332373E-09 4.03456259390E-09 4.15743323653E-09 4.28404584316E-09 4.41451437337E-09 4.54895625727E-09 4.68749250128E-09 4.83024779697E-09 4.97735063333E-09 5.12893341242E-09 5.28513256852E-09 5.44608869093E-09 5.61194665054E-09 5.78285573017E-09 5.95896975898E-09 6.14044725091E-09 6.32745154733E-09 6.52015096410E-09 6.71871894302E-09 6.92333420797E-09 7.13418092575E-09 7.35144887186E-09 7.57533360128E-09 7.80603662453E-09 8.04376558898E-09 8.28873446580E-09 8.54116374249E-09 8.80128062140E-09 9.06931922415E-09 9.34552080242E-09 9.63013395503E-09 9.92341485175E-09 1.02256274638E-08 1.05370438015E-08 1.08579441592E-08 1.11886173671E-08 1.15293610519E-08 1.18804819041E-08 1.22422959543E-08 1.26151288578E-08 1.29993161871E-08 1.33952037349E-08 1.38031478242E-08 1.42235156300E-08 1.46566855093E-08 1.51030473414E-08 1.55630028795E-08 1.60369661118E-08 1.65253636341E-08 1.70286350339E-08 1.75472332862E-08 1.80816251608E-08 1.86322916429E-08 1.91997283656E-08 1.97844460560E-08 2.03869709954E-08 2.10078454924E-08 2.16476283711E-08 2.23068954743E-08 2.29862401817E-08 2.36862739438E-08 2.44076268326E-08 2.51509481082E-08 2.59169068036E-08 2.67061923264E-08 2.75195150800E-08 2.83576071022E-08 2.92212227246E-08 3.01111392514E-08 3.10281576589E-08 3.19731033163E-08 3.29468267291E-08 3.39502043041E-08 3.49841391381E-08 3.60495618312E-08 3.71474313242E-08 3.82787357614E-08 3.94444933803E-08 4.06457534278E-08 4.18835971048E-08 4.31591385393E-08 4.44735257888E-08 4.58279418741E-08 4.72236058436E-08 4.86617738709E-08 5.01437403849E-08 5.16708392355E-08 5.32444448932E-08 5.48659736872E-08 5.65368850793E-08 5.82586829778E-08 6.00329170911E-08 6.18611843224E-08 6.37451302068E-08 6.56864503927E-08 6.76868921676E-08 6.97482560307E-08 7.18723973137E-08 7.40612278502E-08 7.63167176966E-08 7.86408969055E-08 8.10358573521E-08 8.35037546174E-08 8.60468099284E-08 8.86673121567E-08 9.13676198789E-08 9.41501634992E-08 9.70174474370E-08 9.99720523805E-08 1.03016637610E-07 1.06153943390E-07 1.09386793437E-07 1.12718097461E-07 1.16150853782E-07 1.19688152029E-07 1.23333175925E-07 1.27089206146E-07 1.30959623277E-07 1.34947910855E-07 1.39057658503E-07 1.43292565160E-07 1.47656442412E-07 1.52153217921E-07 1.56786938959E-07 1.61561776052E-07 1.66482026736E-07 1.71552119416E-07 1.76776617363E-07 1.82160222812E-07 1.87707781198E-07 1.93424285514E-07 1.99314880809E-07 2.05384868815E-07 2.11639712718E-07 2.18085042078E-07 2.24726657890E-07 2.31570537813E-07 2.38622841539E-07 2.45889916347E-07 2.53378302807E-07 2.61094740673E-07 2.69046174943E-07 2.77239762111E-07 2.85682876610E-07 2.94383117445E-07 3.03348315034E-07 3.12586538253E-07 3.22106101699E-07 3.31915573174E-07 3.42023781392E-07 3.52439823926E-07 3.63173075396E-07 3.74233195905E-07 3.85630139731E-07 3.97374164286E-07 4.09475839348E-07 4.21946056573E-07 4.34796039292E-07 4.48037352618E-07 4.61681913847E-07 4.75742003189E-07 4.90230274812E-07 5.05159768234E-07 5.20543920058E-07 5.36396576057E-07 5.52732003644E-07 5.69564904699E-07 5.86910428811E-07 6.04784186899E-07 6.23202265271E-07 6.42181240091E-07 6.61738192299E-07 6.81890722981E-07 7.02656969209E-07 7.24055620356E-07 7.46105934923E-07 7.68827757859E-07 7.92241538424E-07 8.16368348589E-07 8.41229901995E-07 8.66848573496E-07 8.93247419285E-07 9.20450197648E-07 9.48481390337E-07 9.77366224601E-07 1.00713069588E-06 1.03780159122E-06 1.06940651332E-06 1.10197390544E-06 1.13553307694E-06 1.17011422966E-06 1.20574848513E-06 1.24246791253E-06 1.28030555756E-06 1.31929547217E-06 1.35947274521E-06 1.40087353399E-06 1.44353509681E-06 1.48749582647E-06 1.53279528486E-06 1.57947423850E-06 1.62757469524E-06 1.67713994204E-06 1.72821458396E-06 1.78084458424E-06 1.83507730565E-06 1.89096155316E-06 1.94854761776E-06 2.00788732178E-06 2.06903406549E-06 2.13204287509E-06 2.19697045230E-06 2.26387522529E-06 2.33281740128E-06 2.40385902072E-06 2.47706401306E-06 2.55249825425E-06 2.63022962606E-06 2.71032807711E-06 2.79286568574E-06 2.87791672496E-06 2.96555772914E-06 3.05586756293E-06 3.14892749217E-06 3.24482125700E-06 3.34363514717E-06 3.44545807965E-06 3.55038167862E-06 3.65850035786E-06 3.76991140569E-06 3.88471507247E-06 4.00301466073E-06 4.12491661814E-06 4.25053063316E-06 4.37996973379E-06 4.51335038912E-06 4.65079261414E-06 4.79242007766E-06 4.93836021350E-06 5.08874433509E-06 5.24370775359E-06 5.40338989953E-06 5.56793444820E-06 5.73748944885E-06 5.91220745780E-06 6.09224567565E-06 6.27776608857E-06 6.46893561400E-06 6.66592625069E-06 6.86891523339E-06 7.07808519214E-06 7.29362431650E-06 7.51572652474E-06 7.74459163815E-06 7.98042556072E-06 8.22344046420E-06 8.47385497885E-06 8.73189438998E-06 8.99779084045E-06 9.27178353933E-06 9.55411897694E-06 9.84505114639E-06 1.01448417718E-05 1.04537605438E-05 1.07720853615E-05 1.11001025825E-05 1.14381072803E-05 1.17864035093E-05 1.21453045781E-05 1.25151333312E-05 1.28962224389E-05 1.32889146961E-05 1.36935633307E-05 1.41105323207E-05 1.45401967214E-05 1.49829430021E-05 1.54391693934E-05 1.59092862454E-05 1.63937163954E-05 1.68928955486E-05 1.74072726692E-05 1.79373103833E-05 1.84834853951E-05 1.90462889145E-05 1.96262270984E-05 2.02238215054E-05 2.08396095640E-05 2.14741450554E-05 2.21279986107E-05 2.28017582228E-05 2.34960297753E-05 2.42114375855E-05 2.49486249656E-05 2.57082547996E-05 2.64910101388E-05 2.72975948149E-05 2.81287340715E-05 2.89851752151E-05 2.98676882860E-05 3.07770667488E-05 3.17141282052E-05 3.26797151270E-05 3.36746956121E-05 3.46999641639E-05 3.57564424929E-05 3.68450803443E-05 3.79668563494E-05 3.91227789038E-05 4.03138870717E-05 4.15412515173E-05 4.28059754657E-05 4.41091956915E-05 4.54520835384E-05 4.68358459692E-05 4.82617266479E-05 4.97310070546E-05 5.12450076337E-05 5.28050889778E-05 5.44126530471E-05 5.60691444251E-05 5.77760516135E-05 5.95349083657E-05 6.13472950603E-05 6.32148401176E-05 6.51392214573E-05 6.71221680019E-05 6.91654612241E-05 7.12709367428E-05 7.34404859660E-05 7.56760577839E-05 7.79796603137E-05 8.03533626966E-05 8.27992969495E-05 8.53196598728E-05 8.79167150157E-05 9.05927947011E-05 9.33503021118E-05 9.61917134395E-05 9.91195800997E-05 1.02136531012E-04 1.05245274951E-04 1.08448602967E-04 1.11749390882E-04 1.15150601856E-04 1.18655289038E-04 1.22266598292E-04 1.25987771007E-04 1.29822146990E-04 1.33773167453E-04 1.37844378078E-04 1.42039432187E-04 1.46362094003E-04 1.50816242004E-04 1.55405872386E-04 1.60135102629E-04 1.65008175164E-04 1.70029461162E-04 1.75203464426E-04 1.80534825405E-04 1.86028325331E-04 1.91688890479E-04 1.97521596553E-04 2.03531673205E-04 2.09724508695E-04 2.16105654682E-04 2.22680831169E-04 2.29455931590E-04 2.36437028050E-04 2.43630376728E-04 2.51042423436E-04 2.58679809350E-04 2.66549376911E-04 2.74658175901E-04 2.83013469704E-04 2.91622741757E-04 3.00493702191E-04 3.09634294669E-04 3.19052703436E-04 3.28757360575E-04 3.38756953481E-04 3.49060432560E-04 3.59677019159E-04 3.70616213730E-04 3.81887804242E-04 3.93501874845E-04 4.05468814786E-04 4.17799327600E-04 4.30504440573E-04 4.43595514482E-04 4.57084253631E-04 4.70982716188E-04 4.85303324826E-04 5.00058877680E-04 5.15262559635E-04 5.30927953948E-04 5.47069054212E-04 5.63700276683E-04 5.80836472968E-04 5.98492943090E-04 6.16685448944E-04 6.35430228148E-04 6.54744008310E-04 6.74644021711E-04 6.95148020431E-04 7.16274291912E-04 7.38041674995E-04 7.60469576416E-04 7.83577987801E-04 8.07387503156E-04 8.31919336877E-04 8.57195342287E-04 8.83238030718E-04 9.10070591163E-04 9.37716910495E-04 9.66201594286E-04 9.95549988233E-04 1.02578820022E-03 1.05694312302E-03 1.08904245765E-03 1.12211473745E-03 1.15618935282E-03 1.19129657667E-03 1.22746759069E-03 1.26473451231E-03 1.30313042244E-03 1.34268939411E-03 1.38344652178E-03 1.42543795171E-03 1.46870091299E-03 1.51327374963E-03 1.55919595350E-03 1.60650819827E-03 1.65525237424E-03 1.70547162427E-03 1.75721038070E-03 1.81051440332E-03 1.86543081842E-03 1.92200815903E-03 1.98029640618E-03 2.04034703149E-03 2.10221304082E-03 2.16594901926E-03 2.23161117739E-03 2.29925739880E-03 2.36894728897E-03 2.44074222557E-03 2.51470541011E-03 2.59090192110E-03 2.66939876866E-03 2.75026495066E-03 2.83357151044E-03 2.91939159614E-03 3.00780052166E-03 3.09887582931E-03 3.19269735418E-03 3.28934729034E-03 3.38891025878E-03 3.49147337723E-03 3.59712633196E-03 3.70596145140E-03 3.81807378190E-03 3.93356116540E-03 4.05252431934E-03 4.17506691856E-03 4.30129567953E-03 4.43132044673E-03 4.56525428134E-03 4.70321355234E-03 4.84531802992E-03 4.99169098138E-03 5.14245926952E-03 5.29775345361E-03 5.45770789294E-03 5.62246085303E-03 5.79215461457E-03 5.96693558512E-03 6.14695441365E-03 6.33236610793E-03 6.52333015485E-03 6.72001064379E-03 6.92257639289E-03 7.13120107859E-03 7.34606336813E-03 7.56734705539E-03 7.79524119987E-03 8.02994026906E-03 8.27164428401E-03 8.52055896845E-03 8.77689590124E-03 9.04087267229E-03 9.31271304205E-03 9.59264710453E-03 9.88091145388E-03 1.01777493546E-02 1.04834109156E-02 1.07981532674E-02 1.11222407438E-02 1.14559450664E-02 1.17995455337E-02 1.21533292134E-02 1.25175911385E-02 1.28926345073E-02 1.32787708870E-02 1.36763204209E-02 1.40856120398E-02 1.45069836762E-02 1.49407824830E-02 1.53873650548E-02 1.58470976539E-02 1.63203564382E-02 1.68075276939E-02 1.73090080703E-02 1.78252048185E-02 1.83565360324E-02 1.89034308930E-02 1.94663299154E-02 2.00456851978E-02 2.06419606732E-02 2.12556323634E-02 2.18871886336E-02 2.25371304505E-02 2.32059716398E-02 2.38942391456E-02 2.46024732904E-02 2.53312280348E-02 2.60810712373E-02 2.68525849136E-02 2.76463654945E-02 2.84630240822E-02 2.93031867042E-02 3.01674945649E-02 3.10566042929E-02 3.19711881850E-02 3.29119344445E-02 3.38795474144E-02 3.48747478032E-02 3.58982729040E-02 3.69508768044E-02 3.80333305874E-02 3.91464225209E-02 4.02909582361E-02 4.14677608920E-02 4.26776713258E-02 4.39215481870E-02 4.52002680543E-02 4.65147255331E-02 4.78658333322E-02 4.92545223178E-02 5.06817415428E-02 5.21484582494E-02 5.36556578428E-02 5.52043438340E-02 5.67955377485E-02 5.84302789993E-02 6.01096247209E-02 6.18346495617E-02 6.36064454316E-02 6.54261212019E-02 6.72948023543E-02 6.92136305751E-02 7.11837632915E-02 7.32063731455E-02 7.52826474027E-02 7.74137872897E-02 7.96010072586E-02 8.18455341712E-02 8.41486064003E-02 8.65114728417E-02 8.89353918333E-02 9.14216299742E-02 9.39714608395E-02 9.65861635848E-02 9.92670214344E-02 1.02015320046E-01 1.04832345750E-01 1.07719383646E-01 1.10677715568E-01 1.13708617890E-01 1.16813359181E-01 1.19993197699E-01 1.23249378704E-01 1.26583131607E-01 1.29995666919E-01 1.33488173019E-01 1.37061812705E-01 1.40717719552E-01 1.44456994040E-01 1.48280699463E-01 1.52189857598E-01 1.56185444142E-01 1.60268383891E-01 1.64439545665E-01 1.68699736973E-01 1.73049698397E-01 1.77490097711E-01 1.82021523704E-01 1.86644479720E-01 1.91359376900E-01 1.96166527119E-01 2.01066135632E-01 2.06058293398E-01 2.11142969106E-01 2.16320000884E-01 2.21589087700E-01 2.26949780458E-01 2.32401472784E-01 2.37943391515E-01 2.43574586891E-01 2.49293922462E-01 2.55100064723E-01 2.60991472484E-01 2.66966385995E-01 2.73022815839E-01 2.79158531623E-01 2.85371050482E-01 2.91657625432E-01 2.98015233592E-01 3.04440564323E-01 3.10930007315E-01 3.17479640667E-01 3.24085219006E-01 3.30742161707E-01 3.37445541256E-01 3.44190071831E-01 3.50970098167E-01 3.57779584773E-01 3.64612105587E-01 3.71460834153E-01 3.78318534404E-01 3.85177552163E-01 3.92029807451E-01 3.98866787716E-01 4.05679542109E-01 4.12458676914E-01 4.19194352267E-01 4.25876280299E-01 4.32493724843E-01 4.39035502841E-01 4.45489987609E-01 4.51845114113E-01 4.58088386399E-01 4.64206887362E-01 4.70187290985E-01 4.76015877231E-01 4.81678549748E-01 4.87160856535E-01 4.92448013739E-01 4.97524932729E-01 5.02376250599E-01 5.06986364229E-01 5.11339468043E-01 5.15419595580E-01 5.19210664961E-01 5.22696528365E-01 5.25861025556E-01 5.28688041506E-01 5.31161568142E-01 5.33265770190E-01 5.34985055073E-01 5.36304146798E-01 5.37208163694E-01 5.37682699852E-01 5.37713910065E-01 5.37288598015E-01 5.36394307392E-01 5.35019415614E-01 5.33153229710E-01 5.30786083918E-01 5.27909438446E-01 5.24515978828E-01 5.20599715198E-01 5.16156080784E-01 5.11182028832E-01 5.05676127126E-01 4.99638649207E-01 4.93071661338E-01 4.85979104205E-01 4.78366868318E-01 4.70242862013E-01 4.61617070945E-01 4.52501607919E-01 4.42910751927E-01 4.32860975222E-01 4.22370957307E-01 4.11461584728E-01 4.00155935609E-01 3.88479247940E-01 3.76458870697E-01 3.64124196984E-01 3.51506578500E-01 3.38639220794E-01 3.25557058912E-01 3.12296613246E-01 2.98895825582E-01 2.85393875590E-01 2.71830978229E-01 2.58248162803E-01 2.44687034687E-01 2.31189521034E-01 2.17797602044E-01 2.04553029718E-01 1.91497036290E-01 1.78670034840E-01 1.66111314878E-01 1.53858735953E-01 1.41948422599E-01 1.30414464137E-01 1.19288623058E-01 1.08600055814E-01 9.83750499863E-02 8.86367817922E-02 7.94050978969E-02 7.06963253928E-02 6.25231136493E-02 5.48943115018E-02 4.78148829351E-02 4.12858640262E-02 3.53043634463E-02 2.98636082824E-02 2.49530363295E-02 2.05584353335E-02 1.66621289389E-02 1.32432083263E-02 1.02778077237E-02 7.73942115623E-03 5.59925698253E-03 3.82662596018E-03 2.38935781608E-03 1.25424058433E-03 3.87476336301E-04 -2.44853614043E-04 -6.76321370560E-04 -9.39690608257E-04 -1.06646797376E-03 -1.08647543598E-03 -1.02745104110E-03 -9.14685061836E-04 -7.70697834876E-04 -6.14964637589E-04 -4.63691752755E-04 -3.28784479982E-04 -2.15591793976E-04 -1.26281254313E-04 -6.09620038054E-05 -1.79167025888E-05 6.08494424624E-06 1.53845556337E-05 1.49390775007E-05 9.72454080047E-06 4.03423958599E-06 6.66728908171E-07 -5.89331859051E-18 -2.04808650905E-17 -2.77235782142E-17 1.24461262466E-17 4.31711979247E-17 4.87927377150E-17 1.62724020722E-17 3.69565881241E-17 2.19763293029E-17 5.10948890697E-17 4.52059392855E-17 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2 4 1 i j (l(j)) 0.00000000000E+00 Q_int 2.46652244279E-10 2.54163922757E-10 2.61904365868E-10 2.69880540530E-10 2.78099625837E-10 2.86569019516E-10 2.95296344590E-10 3.04289456238E-10 3.13556448864E-10 3.23105663383E-10 3.32945694728E-10 3.43085399588E-10 3.53533904377E-10 3.64300613451E-10 3.75395217569E-10 3.86827702619E-10 3.98608358604E-10 4.10747788904E-10 4.23256919819E-10 4.36147010407E-10 4.49429662611E-10 4.63116831710E-10 4.77220837071E-10 4.91754373243E-10 5.06730521384E-10 5.22162761028E-10 5.38064982224E-10 5.54451498036E-10 5.71337057423E-10 5.88736858520E-10 6.06666562311E-10 6.25142306728E-10 6.44180721177E-10 6.63798941503E-10 6.84014625417E-10 7.04845968383E-10 7.26311720003E-10 7.48431200887E-10 7.71224320045E-10 7.94711592805E-10 8.18914159282E-10 8.43853803399E-10 8.69552972501E-10 8.96034797555E-10 9.23323113968E-10 9.51442483045E-10 9.80418214092E-10 1.01027638720E-09 1.04104387671E-09 1.07274837541E-09 1.10541841947E-09 1.13908341409E-09 1.17377366002E-09 1.20952038078E-09 1.24635575080E-09 1.28431292436E-09 1.32342606544E-09 1.36373037847E-09 1.40526214000E-09 1.44805873138E-09 1.49215867238E-09 1.53760165587E-09 1.58442858356E-09 1.63268160278E-09 1.68240414445E-09 1.73364096215E-09 1.78643817241E-09 1.84084329622E-09 1.89690530179E-09 1.95467464863E-09 2.01420333298E-09 2.07554493458E-09 2.13875466493E-09 2.20388941697E-09 2.27100781627E-09 2.34017027381E-09 2.41143904038E-09 2.48487826256E-09 2.56055404049E-09 2.63853448735E-09 2.71888979068E-09 2.80169227554E-09 2.88701646961E-09 2.97493917028E-09 3.06553951374E-09 3.15889904626E-09 3.25510179755E-09 3.35423435638E-09 3.45638594855E-09 3.56164851720E-09 3.67011680552E-09 3.78188844207E-09 3.89706402862E-09 4.01574723074E-09 4.13804487104E-09 4.26406702540E-09 4.39392712195E-09 4.52774204325E-09 4.66563223144E-09 4.80772179666E-09 4.95413862876E-09 5.10501451239E-09 5.26048524564E-09 5.42069076226E-09 5.58577525758E-09 5.75588731835E-09 5.93118005642E-09 6.11181124659E-09 6.29794346859E-09 6.48974425343E-09 6.68738623418E-09 6.89104730134E-09 7.10091076298E-09 7.31716550971E-09 7.54000618466E-09 7.76963335876E-09 8.00625371115E-09 8.25008021531E-09 8.50133233066E-09 8.76023620017E-09 9.02702485382E-09 9.30193841839E-09 9.58522433359E-09 9.87713757475E-09 1.01779408823E-08 1.04879049983E-08 1.08073089100E-08 1.11364401013E-08 1.14755948108E-08 1.18250782993E-08 1.21852051240E-08 1.25562994214E-08 1.29386951999E-08 1.33327366396E-08 1.37387784025E-08 1.41571859514E-08 1.45883358794E-08 1.50326162481E-08 1.54904269375E-08 1.59621800057E-08 1.64483000597E-08 1.69492246375E-08 1.74654046022E-08 1.79973045475E-08 1.85454032161E-08 1.91101939305E-08 1.96921850369E-08 2.02919003628E-08 2.09098796885E-08 2.15466792332E-08 2.22028721550E-08 2.28790490674E-08 2.35758185703E-08 2.42938077985E-08 2.50336629853E-08 2.57960500449E-08 2.65816551712E-08 2.73911854557E-08 2.82253695239E-08 2.90849581909E-08 2.99707251376E-08 3.08834676064E-08 3.18240071192E-08 3.27931902170E-08 3.37918892211E-08 3.48210030189E-08 3.58814578728E-08 3.69742082535E-08 3.81002376995E-08 3.92605597022E-08 4.04562186179E-08 4.16882906080E-08 4.29578846076E-08 4.42661433232E-08 4.56142442616E-08 4.70034007897E-08 4.84348632262E-08 4.99099199672E-08 5.14298986459E-08 5.29961673273E-08 5.46101357395E-08 5.62732565426E-08 5.79870266364E-08 5.97529885070E-08 6.15727316156E-08 6.34478938291E-08 6.53801628939E-08 6.73712779550E-08 6.94230311215E-08 7.15372690795E-08 7.37158947538E-08 7.59608690211E-08 7.82742124743E-08 8.06580072418E-08 8.31143988607E-08 8.56455982083E-08 8.82538834917E-08 9.09416022985E-08 9.37111737093E-08 9.65650904753E-08 9.95059212616E-08 1.02536312959E-07 1.05658993067E-07 1.08876772146E-07 1.12192546351E-07 1.15609300035E-07 1.19130108436E-07 1.22758140444E-07 1.26496661454E-07 1.30349036306E-07 1.34318732309E-07 1.38409322367E-07 1.42624488191E-07 1.46968023615E-07 1.51443838006E-07 1.56055959789E-07 1.60808540067E-07 1.65705856361E-07 1.70752316456E-07 1.75952462370E-07 1.81310974444E-07 1.86832675548E-07 1.92522535429E-07 1.98385675178E-07 2.04427371842E-07 2.10653063172E-07 2.17068352518E-07 2.23679013869E-07 2.30490997054E-07 2.37510433093E-07 2.44743639716E-07 2.52197127049E-07 2.59877603474E-07 2.67791981663E-07 2.75947384802E-07 2.84351153003E-07 2.93010849905E-07 3.01934269485E-07 3.11129443071E-07 3.20604646570E-07 3.30368407916E-07 3.40429514744E-07 3.50797022299E-07 3.61480261586E-07 3.72488847766E-07 3.83832688810E-07 3.95521994416E-07 4.07567285196E-07 4.19979402145E-07 4.32769516394E-07 4.45949139269E-07 4.59530132646E-07 4.73524719627E-07 4.87945495539E-07 5.02805439271E-07 5.18117924951E-07 5.33896733984E-07 5.50156067454E-07 5.66910558901E-07 5.84175287491E-07 6.01965791590E-07 6.20298082739E-07 6.39188660069E-07 6.58654525147E-07 6.78713197272E-07 6.99382729246E-07 7.20681723616E-07 7.42629349412E-07 7.65245359403E-07 7.88550107864E-07 8.12564568899E-07 8.37310355310E-07 8.62809738050E-07 8.89085666256E-07 9.16161787909E-07 9.44062471107E-07 9.72812825993E-07 1.00243872735E-06 1.03296683790E-06 1.06442463225E-06 1.09684042168E-06 1.13024337956E-06 1.16466356762E-06 1.20013196302E-06 1.23668048620E-06 1.27434202961E-06 1.31315048729E-06 1.35314078540E-06 1.39434891361E-06 1.43681195752E-06 1.48056813198E-06 1.52565681552E-06 1.57211858577E-06 1.61999525595E-06 1.66932991249E-06 1.72016695384E-06 1.77255213036E-06 1.82653258552E-06 1.88215689831E-06 1.93947512692E-06 1.99853885380E-06 2.05940123210E-06 2.12211703340E-06 2.18674269710E-06 2.25333638110E-06 2.32195801416E-06 2.39266934986E-06 2.46553402206E-06 2.54061760222E-06 2.61798765839E-06 2.69771381594E-06 2.77986782025E-06 2.86452360122E-06 2.95175733979E-06 3.04164753648E-06 3.13427508198E-06 3.22972332994E-06 3.32807817192E-06 3.42942811471E-06 3.53386435987E-06 3.64148088582E-06 3.75237453235E-06 3.86664508775E-06 3.98439537854E-06 4.10573136197E-06 4.23076222132E-06 4.35960046413E-06 4.49236202333E-06 4.62916636160E-06 4.77013657873E-06 4.91539952239E-06 5.06508590221E-06 5.21933040728E-06 5.37827182737E-06 5.54205317767E-06 5.71082182746E-06 5.88472963260E-06 6.06393307212E-06 6.24859338893E-06 6.43887673481E-06 6.63495431983E-06 6.83700256630E-06 7.04520326742E-06 7.25974375072E-06 7.48081704653E-06 7.70862206155E-06 7.94336375764E-06 8.18525333616E-06 8.43450842784E-06 8.69135328844E-06 8.95601900038E-06 9.22874368048E-06 9.50977269404E-06 9.79935887542E-06 1.00977627553E-05 1.04052527950E-05 1.07221056276E-05 1.10486063068E-05 1.13850485631E-05 1.17317350677E-05 1.20889777047E-05 1.24570978514E-05 1.28364266671E-05 1.32273053907E-05 1.36300856474E-05 1.40451297650E-05 1.44728110989E-05 1.49135143680E-05 1.53676360008E-05 1.58355844906E-05 1.63177807635E-05 1.68146585563E-05 1.73266648061E-05 1.78542600518E-05 1.83979188482E-05 1.89581301920E-05 1.95353979613E-05 2.01302413682E-05 2.07431954251E-05 2.13748114254E-05 2.20256574387E-05 2.26963188209E-05 2.33873987400E-05 2.40995187178E-05 2.48333191881E-05 2.55894600720E-05 2.63686213699E-05 2.71715037729E-05 2.79988292914E-05 2.88513419033E-05 2.97298082225E-05 3.06350181867E-05 3.15677857664E-05 3.25289496961E-05 3.35193742268E-05 3.45399499018E-05 3.55915943558E-05 3.66752531388E-05 3.77919005645E-05 3.89425405844E-05 4.01282076891E-05 4.13499678359E-05 4.26089194057E-05 4.39061941882E-05 4.52429583970E-05 4.66204137161E-05 4.80397983772E-05 4.95023882710E-05 5.10094980907E-05 5.25624825115E-05 5.41627374048E-05 5.58117010905E-05 5.75108556256E-05 5.92617281337E-05 6.10658921733E-05 6.29249691485E-05 6.48406297622E-05 6.68145955130E-05 6.88486402385E-05 7.09445917039E-05 7.31043332401E-05 7.53298054306E-05 7.76230078500E-05 7.99860008547E-05 8.24209074282E-05 8.49299150825E-05 8.75152778162E-05 9.01793181332E-05 9.29244291210E-05 9.57530765937E-05 9.86678012979E-05 1.01671221187E-04 1.04766033765E-04 1.07955018495E-04 1.11241039294E-04 1.14627047085E-04 1.18116082444E-04 1.21711278314E-04 1.25415862810E-04 1.29233162101E-04 1.33166603386E-04 1.37219717954E-04 1.41396144345E-04 1.45699631594E-04 1.50134042586E-04 1.54703357503E-04 1.59411677378E-04 1.64263227762E-04 1.69262362488E-04 1.74413567565E-04 1.79721465178E-04 1.85190817811E-04 1.90826532500E-04 1.96633665205E-04 2.02617425325E-04 2.08783180336E-04 2.15136460580E-04 2.21682964195E-04 2.28428562189E-04 2.35379303673E-04 2.42541421250E-04 2.49921336563E-04 2.57525666012E-04 2.65361226647E-04 2.73435042233E-04 2.81754349495E-04 2.90326604563E-04 2.99159489595E-04 3.08260919614E-04 3.17639049535E-04 3.27302281419E-04 3.37259271932E-04 3.47518940037E-04 3.58090474908E-04 3.68983344090E-04 3.80207301900E-04 3.91772398077E-04 4.03688986699E-04 4.15967735356E-04 4.28619634610E-04 4.41656007728E-04 4.55088520714E-04 4.68929192634E-04 4.83190406256E-04 4.97884919005E-04 5.13025874247E-04 5.28626812906E-04 5.44701685433E-04 5.61264864128E-04 5.78331155834E-04 5.95915815008E-04 6.14034557173E-04 6.32703572787E-04 6.51939541513E-04 6.71759646914E-04 6.92181591591E-04 7.13223612767E-04 7.34904498336E-04 7.57243603383E-04 7.80260867205E-04 8.03976830826E-04 8.28412655038E-04 8.53590138971E-04 8.79531739220E-04 9.06260589532E-04 9.33800521077E-04 9.62176083316E-04 9.91412565491E-04 1.02153601874E-03 1.05257327888E-03 1.08455198983E-03 1.11750062777E-03 1.15144852597E-03 1.18642590035E-03 1.22246387583E-03 1.25959451343E-03 1.29785083813E-03 1.33726686759E-03 1.37787764174E-03 1.41971925313E-03 1.46282887826E-03 1.50724480982E-03 1.55300648979E-03 1.60015454361E-03 1.64873081525E-03 1.69877840340E-03 1.75034169856E-03 1.80346642140E-03 1.85819966206E-03 1.91458992067E-03 1.97268714905E-03 2.03254279356E-03 2.09420983922E-03 2.15774285511E-03 2.22319804102E-03 2.29063327551E-03 2.36010816533E-03 2.43168409615E-03 2.50542428494E-03 2.58139383362E-03 2.65965978444E-03 2.74029117677E-03 2.82335910559E-03 2.90893678165E-03 2.99709959323E-03 3.08792516979E-03 3.18149344724E-03 3.27788673523E-03 3.37718978614E-03 3.47948986618E-03 3.58487682828E-03 3.69344318724E-03 3.80528419672E-03 3.92049792857E-03 4.03918535424E-03 4.16145042847E-03 4.28740017526E-03 4.41714477622E-03 4.55079766133E-03 4.68847560218E-03 4.83029880772E-03 4.97639102260E-03 5.12687962822E-03 5.28189574645E-03 5.44157434612E-03 5.60605435240E-03 5.77547875905E-03 5.94999474367E-03 6.12975378598E-03 6.31491178923E-03 6.50562920471E-03 6.70207115966E-03 6.90440758831E-03 7.11281336642E-03 7.32746844928E-03 7.54855801313E-03 7.77627260030E-03 8.01080826790E-03 8.25236674035E-03 8.50115556560E-03 8.75738827532E-03 9.02128454897E-03 9.29307038192E-03 9.57297825761E-03 9.86124732391E-03 1.01581235736E-02 1.04638600292E-02 1.07787169323E-02 1.11029619367E-02 1.14368703067E-02 1.17807251198E-02 1.21348174734E-02 1.24994466968E-02 1.28749205673E-02 1.32615555317E-02 1.36596769317E-02 1.40696192350E-02 1.44917262702E-02 1.49263514676E-02 1.53738581042E-02 1.58346195535E-02 1.63090195408E-02 1.67974524026E-02 1.73003233517E-02 1.78180487464E-02 1.83510563647E-02 1.88997856840E-02 1.94646881643E-02 2.00462275372E-02 2.06448800985E-02 2.12611350064E-02 2.18954945831E-02 2.25484746212E-02 2.32206046940E-02 2.39124284699E-02 2.46245040309E-02 2.53574041938E-02 2.61117168358E-02 2.68880452225E-02 2.76870083392E-02 2.85092412244E-02 2.93553953057E-02 3.02261387377E-02 3.11221567409E-02 3.20441519420E-02 3.29928447151E-02 3.39689735215E-02 3.49732952510E-02 3.60065855606E-02 3.70696392117E-02 3.81632704054E-02 3.92883131141E-02 4.04456214090E-02 4.16360697832E-02 4.28605534683E-02 4.41199887448E-02 4.54153132440E-02 4.67474862414E-02 4.81174889393E-02 4.95263247380E-02 5.09750194942E-02 5.24646217645E-02 5.39962030331E-02 5.55708579216E-02 5.71897043791E-02 5.88538838512E-02 6.05645614247E-02 6.23229259478E-02 6.41301901210E-02 6.59875905583E-02 6.78963878160E-02 6.98578663846E-02 7.18733346429E-02 7.39441247709E-02 7.60715926173E-02 7.82571175191E-02 8.05021020697E-02 8.28079718320E-02 8.51761749914E-02 8.76081819459E-02 9.01054848291E-02 9.26695969593E-02 9.53020522135E-02 9.80044043182E-02 1.00778226053E-01 1.03625108364E-01 1.06546659371E-01 1.09544503285E-01 1.12620279199E-01 1.15775639771E-01 1.19012249785E-01 1.22331784573E-01 1.25735928309E-01 1.29226372148E-01 1.32804812224E-01 1.36472947469E-01 1.40232477285E-01 1.44085099019E-01 1.48032505260E-01 1.52076380941E-01 1.56218400233E-01 1.60460223228E-01 1.64803492392E-01 1.69249828791E-01 1.73800828070E-01 1.78458056179E-01 1.83223044831E-01 1.88097286694E-01 1.93082230290E-01 1.98179274602E-01 2.03389763378E-01 2.08714979115E-01 2.14156136722E-01 2.19714376847E-01 2.25390758852E-01 2.31186253448E-01 2.37101734954E-01 2.43137973196E-01 2.49295625019E-01 2.55575225418E-01 2.61977178285E-01 2.68501746746E-01 2.75149043112E-01 2.81919018421E-01 2.88811451579E-01 2.95825938099E-01 3.02961878441E-01 3.10218465951E-01 3.17594674416E-01 3.25089245238E-01 3.32700674230E-01 3.40427198072E-01 3.48266780409E-01 3.56217097650E-01 3.64275524458E-01 3.72439118978E-01 3.80704607836E-01 3.89068370933E-01 3.97526426080E-01 4.06074413525E-01 4.14707580418E-01 4.23420765273E-01 4.32208382480E-01 4.41064406955E-01 4.49982358984E-01 4.58955289352E-01 4.67975764840E-01 4.77035854199E-01 4.86127114684E-01 4.95240579273E-01 5.04366744693E-01 5.13495560358E-01 5.22616418382E-01 5.31718144789E-01 5.40788992073E-01 5.49816633277E-01 5.58788157744E-01 5.67690068722E-01 5.76508282997E-01 5.85228132744E-01 5.93834369791E-01 6.02311172490E-01 6.10642155394E-01 6.18810381956E-01 6.26798380457E-01 6.34588163353E-01 6.42161250284E-01 6.49498694920E-01 6.56581115865E-01 6.63388731812E-01 6.69901401136E-01 6.76098666107E-01 6.81959801880E-01 6.87463870431E-01 6.92589779537E-01 6.97316346944E-01 7.01622369779E-01 7.05486699265E-01 7.08888320769E-01 7.11806439153E-01 7.14220569369E-01 7.16110632209E-01 7.17457055042E-01 7.18240877330E-01 7.18443860678E-01 7.18048603065E-01 7.17038656892E-01 7.15398650363E-01 7.13114411684E-01 7.10173095463E-01 7.06563310633E-01 7.02275249127E-01 6.97300814466E-01 6.91633749340E-01 6.85269761165E-01 6.78206644549E-01 6.70444399507E-01 6.61985344187E-01 6.52834220832E-01 6.42998293618E-01 6.32487436963E-01 6.21314212886E-01 6.09493935927E-01 5.97044724171E-01 5.83987534881E-01 5.70346183293E-01 5.56147343156E-01 5.41420527647E-01 5.26198049400E-01 5.10514958468E-01 4.94408957195E-01 4.77920291091E-01 4.61091615057E-01 4.43967834430E-01 4.26595920651E-01 4.09024701542E-01 3.91304626531E-01 3.73487507446E-01 3.55626235849E-01 3.37774478232E-01 3.19986350775E-01 3.02316075739E-01 2.84817621962E-01 2.67544332311E-01 2.50548541316E-01 2.33881186600E-01 2.17591418039E-01 2.01726208911E-01 1.86329973592E-01 1.71444196540E-01 1.57107077540E-01 1.43353198246E-01 1.30213215119E-01 1.17713583820E-01 1.05876319963E-01 9.47188009399E-02 8.42536131923E-02 7.44884488794E-02 6.54260553883E-02 5.70642404905E-02 4.93959352392E-02 4.24093158893E-02 3.60879852236E-02 3.04112127069E-02 2.53542318605E-02 2.08885921811E-02 1.69825618365E-02 1.36015762698E-02 1.07087267676E-02 8.26528200788E-03 6.23123463450E-03 4.56586403028E-03 3.22830570370E-03 2.17811709656E-03 1.37582918440E-03 7.83473005003E-04 3.65070237362E-04 8.70771868812E-05 -8.12279653325E-05 -1.67424001325E-04 -1.95699849445E-04 -1.86688950476E-04 -1.57389894164E-04 -1.20564490013E-04 -8.34578149901E-05 -5.05797294951E-05 -2.46029668289E-05 -6.58408502577E-06 3.76429533341E-06 7.75173662735E-06 7.34180281936E-06 4.74203915899E-06 1.95838600082E-06 3.22182205081E-07 -3.53821100510E-18 8.99853046253E-18 -1.35097742673E-18 5.21310782431E-18 -8.21959871147E-18 3.43331153752E-18 -2.41943725230E-17 4.24224314039E-21 9.91034147998E-18 4.19011776384E-18 5.66015972742E-18 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 3 3 1 i j (l(j)) 2.29673425940E-01 Q_int 1.44088759235E-13 1.49969131784E-13 1.56089486811E-13 1.62459618182E-13 1.69089719457E-13 1.75990400205E-13 1.83172702976E-13 1.90648120978E-13 1.98428616464E-13 2.06526639875E-13 2.14955149765E-13 2.23727633533E-13 2.32858129013E-13 2.42361246931E-13 2.52252194287E-13 2.62546798691E-13 2.73261533689E-13 2.84413545125E-13 2.96020678577E-13 3.08101507913E-13 3.20675365017E-13 3.33762370719E-13 3.47383466995E-13 3.61560450479E-13 3.76316007341E-13 3.91673749591E-13 4.07658252861E-13 4.24295095734E-13 4.41610900671E-13 4.59633376617E-13 4.78391363338E-13 4.97914877574E-13 5.18235161066E-13 5.39384730556E-13 5.61397429815E-13 5.84308483806E-13 6.08154555045E-13 6.32973802272E-13 6.58805941514E-13 6.85692309636E-13 7.13675930489E-13 7.42801583761E-13 7.73115876627E-13 8.04667318336E-13 8.37506397834E-13 8.71685664556E-13 9.07259812516E-13 9.44285767828E-13 9.82822779804E-13 1.02293251576E-12 1.06467915969E-12 1.10812951500E-12 1.15335311138E-12 1.20042231606E-12 1.24941244965E-12 1.30040190664E-12 1.35347228084E-12 1.40870849597E-12 1.46619894155E-12 1.52603561432E-12 1.58831426549E-12 1.65313455393E-12 1.72060020566E-12 1.79081917982E-12 1.86390384144E-12 1.93997114124E-12 2.01914280280E-12 2.10154551728E-12 2.18731114623E-12 2.27657693253E-12 2.36948572004E-12 2.46618618217E-12 2.56683305980E-12 2.67158740887E-12 2.78061685814E-12 2.89409587738E-12 3.01220605661E-12 3.13513639663E-12 3.26308361151E-12 3.39625244333E-12 3.53485598982E-12 3.67911604538E-12 3.82926345597E-12 3.98553848851E-12 4.14819121538E-12 4.31748191455E-12 4.49368148611E-12 4.67707188574E-12 4.86794657591E-12 5.06661099545E-12 5.27338304837E-12 5.48859361251E-12 5.71258706902E-12 5.94572185348E-12 6.18837102942E-12 6.44092288530E-12 6.70378155588E-12 6.97736766888E-12 7.26211901809E-12 7.55849126389E-12 7.86695866244E-12 8.18801482456E-12 8.52217350559E-12 8.86996942751E-12 9.23195913461E-12 9.60872188404E-12 1.00008605728E-11 1.04090027023E-11 1.08338013827E-11 1.12759363781E-11 1.17361151938E-11 1.22150742090E-11 1.27135798547E-11 1.32324298406E-11 1.37724544312E-11 1.43345177744E-11 1.49195192845E-11 1.55283950814E-11 1.61621194883E-11 1.68217065912E-11 1.75082118613E-11 1.82227338440E-11 1.89664159171E-11 1.97404481198E-11 2.05460690576E-11 2.13845678838E-11 2.22572863628E-11 2.31656210169E-11 2.41110253609E-11 2.50950122283E-11 2.61191561919E-11 2.71850960833E-11 2.82945376157E-11 2.94492561127E-11 3.06510993498E-11 3.19019905109E-11 3.32039312655E-11 3.45590049719E-11 3.59693800112E-11 3.74373132565E-11 3.89651536849E-11 4.05553461357E-11 4.22104352229E-11 4.39330694069E-11 4.57260052326E-11 4.75921117400E-11 4.95343750556E-11 5.15559031701E-11 5.36599309124E-11 5.58498251253E-11 5.81290900529E-11 6.05013729487E-11 6.29704699108E-11 6.55403319570E-11 6.82150713466E-11 7.09989681611E-11 7.38964771523E-11 7.69122348712E-11 8.00510670870E-11 8.33179965087E-11 8.67182508229E-11 9.02572710580E-11 9.39407202914E-11 9.77744927108E-11 1.01764723046E-10 1.05917796384E-10 1.10240358389E-10 1.14739325934E-10 1.19421898168E-10 1.24295568039E-10 1.29368134280E-10 1.34647713890E-10 1.40142755123E-10 1.45862051003E-10 1.51814753398E-10 1.58010387662E-10 1.64458867875E-10 1.71170512711E-10 1.78156061947E-10 1.85426693645E-10 1.92994042044E-10 2.00870216170E-10 2.09067819217E-10 2.17599968711E-10 2.26480317498E-10 2.35723075594E-10 2.45343032918E-10 2.55355582962E-10 2.65776747416E-10 2.76623201811E-10 2.87912302197E-10 2.99662112916E-10 3.11891435504E-10 3.24619838781E-10 3.37867690155E-10 3.51656188216E-10 3.66007396658E-10 3.80944279575E-10 3.96490738212E-10 4.12671649205E-10 4.29512904388E-10 4.47041452217E-10 4.65285340896E-10 4.84273763249E-10 5.04037103433E-10 5.24606985557E-10 5.46016324276E-10 5.68299377462E-10 5.91491801013E-10 6.15630705907E-10 6.40754717579E-10 6.66904037726E-10 6.94120508625E-10 7.22447680088E-10 7.51930879139E-10 7.82617282536E-10 8.14555992261E-10 8.47798114077E-10 8.82396839299E-10 9.18407529903E-10 9.55887807101E-10 9.94897643537E-10 1.03549945924E-09 1.07775822150E-09 1.12174154880E-09 1.16751981903E-09 1.21516628207E-09 1.26475717697E-09 1.31637185397E-09 1.37009290143E-09 1.42600627797E-09 1.48420145001E-09 1.54477153490E-09 1.60781344989E-09 1.67342806721E-09 1.74172037546E-09 1.81279964757E-09 1.88677961562E-09 1.96377865282E-09 2.04391996287E-09 2.12733177710E-09 2.21414755960E-09 2.30450622077E-09 2.39855233952E-09 2.49643639464E-09 2.59831500545E-09 2.70435118247E-09 2.81471458814E-09 2.92958180826E-09 3.04913663454E-09 3.17357035856E-09 3.30308207787E-09 3.43787901448E-09 3.57817684634E-09 3.72420005242E-09 3.87618227181E-09 4.03436667749E-09 4.19900636534E-09 4.37036475905E-09 4.54871603147E-09 4.73434554330E-09 4.92755029951E-09 5.12863942450E-09 5.33793465659E-09 5.55577086272E-09 5.78249657410E-09 6.01847454374E-09 6.26408232679E-09 6.51971288439E-09 6.78577521237E-09 7.06269499541E-09 7.35091528800E-09 7.65089722315E-09 7.96312074999E-09 8.28808540149E-09 8.62631109351E-09 8.97833895641E-09 9.34473220059E-09 9.72607701737E-09 1.01229835166E-08 1.05360867026E-08 1.09660474896E-08 1.14135537591E-08 1.18793214599E-08 1.23640957536E-08 1.28686522057E-08 1.33937980268E-08 1.39403733630E-08 1.45092526401E-08 1.51013459619E-08 1.57176005655E-08 1.63590023367E-08 1.70265773865E-08 1.77213936919E-08 1.84445628042E-08 1.91972416266E-08 1.99806342641E-08 2.07959939492E-08 2.16446250462E-08 2.25278851369E-08 2.34471871915E-08 2.44040018283E-08 2.53998596651E-08 2.64363537670E-08 2.75151421935E-08 2.86379506501E-08 2.98065752472E-08 3.10228853726E-08 3.22888266800E-08 3.36064242005E-08 3.49777855798E-08 3.64051044483E-08 3.78906639287E-08 3.94368402856E-08 4.10461067250E-08 4.27210373485E-08 4.44643112681E-08 4.62787168898E-08 4.81671563708E-08 5.01326502593E-08 5.21783423231E-08 5.43075045749E-08 5.65235425029E-08 5.88300005146E-08 6.12305676018E-08 6.37290832380E-08 6.63295435147E-08 6.90361075289E-08 7.18531040306E-08 7.47850383410E-08 7.78365995537E-08 8.10126680283E-08 8.43183231902E-08 8.77588516479E-08 9.13397556416E-08 9.50667618359E-08 9.89458304707E-08 1.02983164886E-07 1.07185221432E-07 1.11558719790E-07 1.16110653703E-07 1.20848302155E-07 1.25779240997E-07 1.30911355055E-07 1.36252850722E-07 1.41812269069E-07 1.47598499494E-07 1.53620793914E-07 1.59888781554E-07 1.66412484317E-07 1.73202332800E-07 1.80269182951E-07 1.87624333406E-07 1.95279543537E-07 2.03247052228E-07 2.11539597423E-07 2.20170436468E-07 2.29153367275E-07 2.38502750361E-07 2.48233531772E-07 2.58361266948E-07 2.68902145559E-07 2.79873017348E-07 2.91291419033E-07 3.03175602299E-07 3.15544562932E-07 3.28418071142E-07 3.41816703113E-07 3.55761873846E-07 3.70275871332E-07 3.85381892125E-07 4.01104078351E-07 4.17467556232E-07 4.34498476178E-07 4.52224054507E-07 4.70672616865E-07 4.89873643411E-07 5.09857815844E-07 5.30657066342E-07 5.52304628492E-07 5.74835090289E-07 5.98284449300E-07 6.22690170061E-07 6.48091243820E-07 6.74528250699E-07 7.02043424391E-07 7.30680719492E-07 7.60485881559E-07 7.91506520026E-07 8.23792184086E-07 8.57394441654E-07 8.92366961536E-07 9.28765598951E-07 9.66648484519E-07 1.00607611687E-06 1.04711145900E-06 1.08982003860E-06 1.13427005237E-06 1.18053247466E-06 1.22868117046E-06 1.27879301302E-06 1.33094800625E-06 1.38522941204E-06 1.44172388281E-06 1.50052159943E-06 1.56171641469E-06 1.62540600270E-06 1.69169201421E-06 1.76068023837E-06 1.83248077099E-06 1.90720818964E-06 1.98498173581E-06 2.06592550459E-06 2.15016864188E-06 2.23784554971E-06 2.32909609986E-06 2.42406585615E-06 2.52290630569E-06 2.62577509961E-06 2.73283630342E-06 2.84426065765E-06 2.96022584893E-06 3.08091679216E-06 3.20652592403E-06 3.33725350849E-06 3.47330795452E-06 3.61490614688E-06 3.76227379015E-06 3.91564576672E-06 4.07526650933E-06 4.24139038857E-06 4.41428211624E-06 4.59421716478E-06 4.78148220395E-06 4.97637555490E-06 5.17920766280E-06 5.39030158847E-06 5.60999351992E-06 5.83863330455E-06 6.07658500286E-06 6.32422746450E-06 6.58195492764E-06 6.85017764247E-06 7.12932251992E-06 7.41983380655E-06 7.72217378666E-06 8.03682351273E-06 8.36428356532E-06 8.70507484362E-06 9.05973938781E-06 9.42884123469E-06 9.81296730760E-06 1.02127283424E-05 1.06287598504E-05 1.10617231208E-05 1.15123062621E-05 1.19812252870E-05 1.24692252402E-05 1.29770813708E-05 1.35056003534E-05 1.40556215571E-05 1.46280183657E-05 1.52236995513E-05 1.58436107029E-05 1.64887357115E-05 1.71600983166E-05 1.78587637125E-05 1.85858402212E-05 1.93424810304E-05 2.01298860024E-05 2.09493035550E-05 2.18020326177E-05 2.26894246660E-05 2.36128858378E-05 2.45738791332E-05 2.55739267032E-05 2.66146122296E-05 2.76975833997E-05 2.88245544800E-05 2.99973089923E-05 3.12177024966E-05 3.24876654854E-05 3.38092063924E-05 3.51844147216E-05 3.66154643009E-05 3.81046166646E-05 3.96542245710E-05 4.12667356595E-05 4.29446962527E-05 4.46907553093E-05 4.65076685345E-05 4.83983026525E-05 5.03656398486E-05 5.24127823871E-05 5.45429574119E-05 5.67595219369E-05 5.90659680333E-05 6.14659282223E-05 6.39631810799E-05 6.65616570631E-05 6.92654445652E-05 7.20787962102E-05 7.50061353939E-05 7.80520630830E-05 8.12213648802E-05 8.45190183679E-05 8.79502007381E-05 9.15202967232E-05 9.52349068354E-05 9.90998559294E-05 1.03121202099E-04 1.07305245923E-04 1.11658540067E-04 1.16187899265E-04 1.20900410685E-04 1.25803444701E-04 1.30904666078E-04 1.36212045601E-04 1.41733872142E-04 1.47478765205E-04 1.53455687949E-04 1.59673960716E-04 1.66143275084E-04 1.72873708457E-04 1.79875739219E-04 1.87160262469E-04 1.94738606360E-04 2.02622549066E-04 2.10824336394E-04 2.19356700079E-04 2.28232876761E-04 2.37466627702E-04 2.47072259243E-04 2.57064644041E-04 2.67459243111E-04 2.78272128704E-04 2.89520008049E-04 3.01220247989E-04 3.13390900551E-04 3.26050729470E-04 3.39219237713E-04 3.52916696035E-04 3.67164172600E-04 3.81983563706E-04 3.97397625661E-04 4.13430007838E-04 4.30105286952E-04 4.47449002618E-04 4.65487694207E-04 4.84248939072E-04 5.03761392166E-04 5.24054827124E-04 5.45160178841E-04 5.67109587602E-04 5.89936444817E-04 6.13675440419E-04 6.38362611973E-04 6.64035395553E-04 6.90732678455E-04 7.18494853796E-04 7.47363877063E-04 7.77383324678E-04 8.08598454644E-04 8.41056269331E-04 8.74805580483E-04 9.09897076503E-04 9.46383392096E-04 9.84319180336E-04 1.02376118725E-03 1.06476832894E-03 1.10740177145E-03 1.15172501325E-03 1.19780397063E-03 1.24570706597E-03 1.29550531900E-03 1.34727244109E-03 1.40108493275E-03 1.45702218437E-03 1.51516658028E-03 1.57560360622E-03 1.63842196040E-03 1.70371366810E-03 1.77157420004E-03 1.84210259448E-03 1.91540158333E-03 1.99157772216E-03 2.07074152433E-03 2.15300759938E-03 2.23849479562E-03 2.32732634715E-03 2.41963002538E-03 2.51553829512E-03 2.61518847535E-03 2.71872290478E-03 2.82628911225E-03 2.93803999210E-03 3.05413398466E-03 3.17473526176E-03 3.30001391757E-03 3.43014616470E-03 3.56531453569E-03 3.70570808996E-03 3.85152262632E-03 4.00296090101E-03 4.16023285148E-03 4.32355582577E-03 4.49315481774E-03 4.66926270798E-03 4.85212051068E-03 5.04197762612E-03 5.23909209923E-03 5.44373088380E-03 5.65617011258E-03 5.87669537321E-03 6.10560198982E-03 6.34319531031E-03 6.58979099934E-03 6.84571533667E-03 7.11130552106E-03 7.38690997927E-03 7.67288868030E-03 7.96961345440E-03 8.27746831692E-03 8.59684979652E-03 8.92816726762E-03 9.27184328675E-03 9.62831393239E-03 9.99802914811E-03 1.03814530884E-02 1.07790644668E-02 1.11913569062E-02 1.16188392896E-02 1.20620361126E-02 1.25214878355E-02 1.29977512344E-02 1.34913997516E-02 1.40030238432E-02 1.45332313243E-02 1.50826477094E-02 1.56519165484E-02 1.62416997562E-02 1.68526779351E-02 1.74855506886E-02 1.81410369255E-02 1.88198751522E-02 1.95228237532E-02 2.02506612561E-02 2.10041865810E-02 2.17842192718E-02 2.25915997082E-02 2.34271892944E-02 2.42918706250E-02 2.51865476242E-02 2.61121456555E-02 2.70696116009E-02 2.80599139054E-02 2.90840425852E-02 3.01430091955E-02 3.12378467558E-02 3.23696096285E-02 3.35393733480E-02 3.47482343972E-02 3.59973099256E-02 3.72877374078E-02 3.86206742365E-02 3.99972972462E-02 4.14188021635E-02 4.28864029788E-02 4.44013312355E-02 4.59648352313E-02 4.75781791259E-02 4.92426419513E-02 5.09595165179E-02 5.27301082117E-02 5.45557336766E-02 5.64377193756E-02 5.83774000260E-02 6.03761169005E-02 6.24352159904E-02 6.45560460229E-02 6.67399563258E-02 6.89882945355E-02 7.13024041383E-02 7.36836218413E-02 7.61332747650E-02 7.86526774513E-02 8.12431286803E-02 8.39059080898E-02 8.66422725907E-02 8.94534525725E-02 9.23406478934E-02 9.53050236479E-02 9.83477057083E-02 1.01469776033E-01 1.04672267741E-01 1.07956159938E-01 1.11322372309E-01 1.14771759455E-01 1.18305104981E-01 1.21923115332E-01 1.25626413381E-01 1.29415531759E-01 1.33290905933E-01 1.37252867041E-01 1.41301634476E-01 1.45437308229E-01 1.49659860996E-01 1.53969130065E-01 1.58364808974E-01 1.62846438967E-01 1.67413400261E-01 1.72064903120E-01 1.76799978782E-01 1.81617470233E-01 1.86516022861E-01 1.91494075016E-01 1.96549848497E-01 2.01681339001E-01 2.06886306559E-01 2.12162266000E-01 2.17506477489E-01 2.22915937156E-01 2.28387367895E-01 2.33917210349E-01 2.39501614156E-01 2.45136429499E-01 2.50817199024E-01 2.56539150181E-01 2.62297188070E-01 2.68085888840E-01 2.73899493723E-01 2.79731903795E-01 2.85576675505E-01 2.91427017097E-01 2.97275785977E-01 3.03115487129E-01 3.08938272669E-01 3.14735942616E-01 3.20499946994E-01 3.26221389337E-01 3.31891031707E-01 3.37499301316E-01 3.43036298843E-01 3.48491808539E-01 3.53855310218E-01 3.59115993211E-01 3.64262772380E-01 3.69284306257E-01 3.74169017399E-01 3.78905115009E-01 3.83480619895E-01 3.87883391817E-01 3.92101159252E-01 3.96121551623E-01 3.99932133986E-01 4.03520444204E-01 4.06874032571E-01 4.09980503873E-01 4.12827561828E-01 4.15403055843E-01 4.17695030005E-01 4.19691774182E-01 4.21381877119E-01 4.22754281366E-01 4.23798339853E-01 4.24503873916E-01 4.24861232530E-01 4.24861352499E-01 4.24495819321E-01 4.23756928396E-01 4.22637746266E-01 4.21132171504E-01 4.19234994861E-01 4.16941958275E-01 4.14249812291E-01 4.11156371442E-01 4.07660567120E-01 4.03762497444E-01 3.99463473633E-01 3.94766062360E-01 3.89674123590E-01 3.84192843382E-01 3.78328761131E-01 3.72089790775E-01 3.65485235461E-01 3.58525795204E-01 3.51223567112E-01 3.43592037750E-01 3.35646067281E-01 3.27401865060E-01 3.18876956381E-01 3.10090140184E-01 3.01061437532E-01 2.91812030782E-01 2.82364193418E-01 2.72741210594E-01 2.62967290533E-01 2.53067466986E-01 2.43067493069E-01 2.32993726850E-01 2.22873009189E-01 2.12732534391E-01 2.02599714335E-01 1.92502036830E-01 1.82466919034E-01 1.72521556852E-01 1.62692771299E-01 1.53006852914E-01 1.43489405341E-01 1.34165189269E-01 1.25057968002E-01 1.16190355907E-01 1.07583671112E-01 9.92577937647E-02 9.12310312479E-02 8.35199917137E-02 7.61394673121E-02 6.91023284683E-02 6.24194305385E-02 5.60995341333E-02 5.01492403469E-02 4.45729420619E-02 3.93727924180E-02 3.45486914351E-02 3.00982916629E-02 2.60170235935E-02 2.22981414149E-02 1.89327895006E-02 1.59100898262E-02 1.32172502677E-02 1.08396934777E-02 8.76120574551E-03 6.96410493063E-03 5.42942621564E-03 4.13712405610E-03 3.06628831715E-03 2.19537218274E-03 1.50242901175E-03 9.65354904453E-04 5.62133343254E-04 2.71077895270E-04 7.10686254340E-05 -5.82224190412E-05 -1.34897102563E-04 -1.71169542112E-04 -1.77230352144E-04 -1.62376616501E-04 -1.34868804301E-04 -1.01788879386E-04 -6.89005914158E-05 -4.05129872920E-05 -1.93482485901E-05 -6.41505174245E-06 -8.88770355738E-07 -2.30664437140E-17 -7.38366352951E-18 -4.08845305864E-18 2.17225730437E-17 9.99994754571E-18 2.71368611735E-18 -1.69118055171E-17 1.43063828683E-18 2.89353048059E-18 9.45510702836E-18 -2.07359810977E-17 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 3 4 1 i j (l(j)) 2.86076278925E-01 Q_int 1.91610222573E-13 1.99429982371E-13 2.07568872513E-13 2.16039916949E-13 2.24856671146E-13 2.34033243780E-13 2.43584319312E-13 2.53525181486E-13 2.63871737789E-13 2.74640544901E-13 2.85848835197E-13 2.97514544313E-13 3.09656339855E-13 3.22293651266E-13 3.35446700920E-13 3.49136536480E-13 3.63385064581E-13 3.78215085881E-13 3.93650331553E-13 4.09715501254E-13 4.26436302653E-13 4.43839492568E-13 4.61952919782E-13 4.80805569606E-13 5.00427610266E-13 5.20850441171E-13 5.42106743166E-13 5.64230530822E-13 5.87257206872E-13 6.11223618858E-13 6.36168118099E-13 6.62130621056E-13 6.89152673212E-13 7.17277515550E-13 7.46550153749E-13 7.77017430201E-13 8.08728098970E-13 8.41732903810E-13 8.76084659359E-13 9.11838335663E-13 9.49051146132E-13 9.87782639097E-13 1.02809479310E-12 1.07005211606E-12 1.11372174853E-12 1.15917357109E-12 1.20648031623E-12 1.25571768466E-12 1.30696446654E-12 1.36030266746E-12 1.41581763975E-12 1.47359821902E-12 1.53373686632E-12 1.59632981609E-12 1.66147723017E-12 1.72928335810E-12 1.79985670386E-12 1.87331019961E-12 1.94976138631E-12 2.02933260186E-12 2.11215117685E-12 2.19834963831E-12 2.28806592181E-12 2.38144359215E-12 2.47863207309E-12 2.57978688649E-12 2.68506990117E-12 2.79464959191E-12 2.90870130905E-12 3.02740755911E-12 3.15095829682E-12 3.27955122907E-12 3.41339213132E-12 3.55269517683E-12 3.69768327944E-12 3.84858845022E-12 4.00565216880E-12 4.16912576971E-12 4.33927084461E-12 4.51635966089E-12 4.70067559734E-12 4.89251359762E-12 5.09218064222E-12 5.29999623971E-12 5.51629293796E-12 5.74141685638E-12 5.97572823968E-12 6.21960203440E-12 6.47342848887E-12 6.73761377769E-12 7.01258065168E-12 7.29876911438E-12 7.59663712615E-12 7.90666133694E-12 8.22933784911E-12 8.56518301122E-12 8.91473424432E-12 9.27855090190E-12 9.65721516502E-12 1.00513329739E-11 1.04615349973E-11 1.08884776423E-11 1.13328441041E-11 1.17953454594E-11 1.22767218045E-11 1.27777434392E-11 1.32992120999E-11 1.38419622422E-11 1.44068623761E-11 1.49948164562E-11 1.56067653278E-11 1.62436882326E-11 1.69066043756E-11 1.75965745563E-11 1.83147028656E-11 1.90621384530E-11 1.98400773656E-11 2.06497644613E-11 2.14924954017E-11 2.23696187246E-11 2.32825380023E-11 2.42327140877E-11 2.52216674515E-11 2.62509806157E-11 2.73223006856E-11 2.84373419855E-11 2.95978888021E-11 3.08057982395E-11 3.20630031909E-11 3.33715154318E-11 3.47334288389E-11 3.61509227407E-11 3.76262654052E-11 3.91618176690E-11 4.07600367153E-11 4.24234800059E-11 4.41548093732E-11 4.59567952803E-11 4.78323212533E-11 4.97843884962E-11 5.18161206929E-11 5.39307690058E-11 5.61317172781E-11 5.84224874485E-11 6.08067451870E-11 6.32883057605E-11 6.58711401379E-11 6.85593813441E-11 7.13573310737E-11 7.42694665743E-11 7.73004478110E-11 8.04551249227E-11 8.37385459834E-11 8.71559650798E-11 9.07128507185E-11 9.44148945768E-11 9.82680206097E-11 1.02278394530E-10 1.06452433673E-10 1.10796817266E-10 1.15318497118E-10 1.20024708738E-10 1.24922982920E-10 1.30021157787E-10 1.35327391338E-10 1.40850174498E-10 1.46598344708E-10 1.52581100064E-10 1.58808014036E-10 1.65289050785E-10 1.72034581111E-10 1.79055399043E-10 1.86362739114E-10 1.93968294337E-10 2.01884234914E-10 2.10123227711E-10 2.18698456527E-10 2.27623643187E-10 2.36913069502E-10 2.46581600120E-10 2.56644706310E-10 2.67118490718E-10 2.78019713137E-10 2.89365817317E-10 3.01174958885E-10 3.13466034389E-10 3.26258711537E-10 3.39573460670E-10 3.53431587512E-10 3.67855267264E-10 3.82867580083E-10 3.98492548019E-10 4.14755173444E-10 4.31681479064E-10 4.49298549554E-10 4.67634574898E-10 4.86718895493E-10 5.06582049097E-10 5.27255819691E-10 5.48773288335E-10 5.71168886102E-10 5.94478449167E-10 6.18739276147E-10 6.43990187785E-10 6.70271589058E-10 6.97625533834E-10 7.26095792155E-10 7.55727920273E-10 7.86569333543E-10 8.18669382285E-10 8.52079430750E-10 8.86852939302E-10 9.23045549957E-10 9.60715175410E-10 9.99922091697E-10 1.04072903464E-09 1.08320130021E-09 1.12740684902E-09 1.17341641507E-09 1.22130361888E-09 1.27114508531E-09 1.32302056618E-09 1.37701306782E-09 1.43320898391E-09 1.49169823371E-09 1.55257440592E-09 1.61593490842E-09 1.68188112410E-09 1.75051857310E-09 1.82195708161E-09 1.89631095762E-09 1.97369917374E-09 2.05424555762E-09 2.13807899002E-09 2.22533361103E-09 2.31614903466E-09 2.41067057224E-09 2.50904946486E-09 2.61144312539E-09 2.71801539029E-09 2.82893678173E-09 2.94438478041E-09 3.06454410951E-09 3.18960703022E-09 3.31977364931E-09 3.45525223929E-09 3.59625957161E-09 3.74302126345E-09 3.89577213867E-09 4.05475660348E-09 4.22022903745E-09 4.39245420046E-09 4.57170765626E-09 4.75827621331E-09 4.95245838361E-09 5.15456486026E-09 5.36491901445E-09 5.58385741283E-09 5.81173035589E-09 6.04890243832E-09 6.29575313233E-09 6.55267739463E-09 6.82008629826E-09 7.09840769017E-09 7.38808687567E-09 7.68958733070E-09 8.00339144329E-09 8.33000128518E-09 8.66993941495E-09 9.02374971393E-09 9.39199825615E-09 9.77527421387E-09 1.01741908000E-08 1.05893862490E-08 1.10215248375E-08 1.14712979475E-08 1.19394251715E-08 1.24266554639E-08 1.29337683389E-08 1.34615751172E-08 1.40109202239E-08 1.45826825389E-08 1.51777768028E-08 1.57971550797E-08 1.64418082801E-08 1.71127677461E-08 1.78111069000E-08 1.85379429621E-08 1.92944387367E-08 2.00818044723E-08 2.09012997971E-08 2.17542357332E-08 2.26419767936E-08 2.35659431641E-08 2.45276129749E-08 2.55285246640E-08 2.65702794378E-08 2.76545438313E-08 2.87830523736E-08 2.99576103614E-08 3.11800967457E-08 3.24524671366E-08 3.37767569303E-08 3.51550845641E-08 3.65896549031E-08 3.80827627666E-08 3.96367965967E-08 4.12542422777E-08 4.29376871106E-08 4.46898239499E-08 4.65134555093E-08 4.84114988423E-08 5.03869900066E-08 5.24430889173E-08 5.45830843997E-08 5.68103994464E-08 5.91285966898E-08 6.15413840977E-08 6.40526209009E-08 6.66663237622E-08 6.93866731976E-08 7.22180202587E-08 7.51648934880E-08 7.82320061574E-08 8.14242638021E-08 8.47467720612E-08 8.82048448387E-08 9.18040127964E-08 9.55500321935E-08 9.94488940866E-08 1.03506833904E-07 1.07730341411E-07 1.12126171082E-07 1.16701352893E-07 1.21463203558E-07 1.26419338217E-07 1.31577682609E-07 1.36946485735E-07 1.42534333034E-07 1.48350160109E-07 1.54403266996E-07 1.60703333027E-07 1.67260432294E-07 1.74085049739E-07 1.81188097911E-07 1.88580934392E-07 1.96275379942E-07 2.04283737384E-07 2.12618811252E-07 2.21293928241E-07 2.30322958500E-07 2.39720337777E-07 2.49501090476E-07 2.59680853653E-07 2.70275901985E-07 2.81303173759E-07 2.92780297920E-07 3.04725622219E-07 3.17158242509E-07 3.30098033233E-07 3.43565679151E-07 3.57582708368E-07 3.72171526697E-07 3.87355453423E-07 4.03158758531E-07 4.19606701441E-07 4.36725571321E-07 4.54542729050E-07 4.73086650874E-07 4.92386973857E-07 5.12474543167E-07 5.33381461294E-07 5.55141139271E-07 5.77788349978E-07 6.01359283617E-07 6.25891605442E-07 6.51424515841E-07 6.77998812862E-07 7.05656957280E-07 7.34443140316E-07 7.64403354109E-07 7.95585465054E-07 8.28039290122E-07 8.61816676291E-07 8.96971583196E-07 9.33560169153E-07 9.71640880673E-07 1.01127454562E-06 1.05252447014E-06 1.09545653959E-06 1.14013932346E-06 1.18664418468E-06 1.23504539331E-06 1.28542024481E-06 1.33784918325E-06 1.39241592934E-06 1.44920761384E-06 1.50831491630E-06 1.56983220942E-06 1.63385770931E-06 1.70049363190E-06 1.76984635559E-06 1.84202659058E-06 1.91714955509E-06 1.99533515868E-06 2.07670819307E-06 2.16139853062E-06 2.24954133099E-06 2.34127725609E-06 2.43675269376E-06 2.53611999060E-06 2.63953769416E-06 2.74717080500E-06 2.85919103898E-06 2.97577710014E-06 3.09711496472E-06 3.22339817663E-06 3.35482815492E-06 3.49161451373E-06 3.63397539521E-06 3.78213781587E-06 3.93633802707E-06 4.09682189001E-06 4.26384526596E-06 4.43767442233E-06 4.61858645509E-06 4.80686972837E-06 5.00282433185E-06 5.20676255660E-06 5.41900939028E-06 5.63990303224E-06 5.86979542963E-06 6.10905283501E-06 6.35805638666E-06 6.61720271225E-06 6.88690455699E-06 7.16759143710E-06 7.45971031973E-06 7.76372633034E-06 8.08012348864E-06 8.40940547425E-06 8.75209642330E-06 9.10874175715E-06 9.47990904456E-06 9.86618889868E-06 1.02681959102E-05 1.06865696180E-05 1.11219755193E-05 1.15751061202E-05 1.20466820283E-05 1.25374530905E-05 1.30481995748E-05 1.35797334014E-05 1.41328994225E-05 1.47085767536E-05 1.53076801587E-05 1.59311614908E-05 1.65800111909E-05 1.72552598463E-05 1.79579798128E-05 1.86892869012E-05 1.94503421310E-05 2.02423535564E-05 2.10665781634E-05 2.19243238442E-05 2.28169514510E-05 2.37458769311E-05 2.47125735485E-05 2.57185741939E-05 2.67654737877E-05 2.78549317785E-05 2.89886747424E-05 3.01684990856E-05 3.13962738552E-05 3.26739436624E-05 3.40035317225E-05 3.53871430162E-05 3.68269675770E-05 3.83252839096E-05 3.98844625451E-05 4.15069697371E-05 4.31953713058E-05 4.49523366344E-05 4.67806428252E-05 4.86831790201E-05 5.06629508938E-05 5.27230853249E-05 5.48668352522E-05 5.70975847247E-05 5.94188541502E-05 6.18343057537E-05 6.43477492509E-05 6.69631477462E-05 6.96846238646E-05 7.25164661254E-05 7.54631355681E-05 7.85292726396E-05 8.17197043532E-05 8.50394517293E-05 8.84937375303E-05 9.20879942988E-05 9.58278727120E-05 9.97192502657E-05 1.03768240297E-04 1.07981201365E-04 1.12364746992E-04 1.16925755795E-04 1.21671382008E-04 1.26609066417E-04 1.31746547722E-04 1.37091874342E-04 1.42653416685E-04 1.48439879885E-04 1.54460317046E-04 1.60724142999E-04 1.67241148580E-04 1.74021515485E-04 1.81075831677E-04 1.88415107406E-04 1.96050791839E-04 2.03994790339E-04 2.12259482402E-04 2.20857740292E-04 2.29802948390E-04 2.39109023284E-04 2.48790434638E-04 2.58862226849E-04 2.69340041540E-04 2.80240140912E-04 2.91579431986E-04 3.03375491765E-04 3.15646593358E-04 3.28411733096E-04 3.41690658669E-04 3.55503898339E-04 3.69872791246E-04 3.84819518866E-04 4.00367137646E-04 4.16539612872E-04 4.33361853804E-04 4.50859750128E-04 4.69060209768E-04 4.87991198113E-04 5.07681778697E-04 5.28162155396E-04 5.49463716188E-04 5.71619078527E-04 5.94662136396E-04 6.18628109086E-04 6.43553591774E-04 6.69476607948E-04 6.96436663745E-04 7.24474804278E-04 7.53633671999E-04 7.83957567189E-04 8.15492510622E-04 8.48286308494E-04 8.82388619689E-04 9.17851025441E-04 9.54727101497E-04 9.93072492840E-04 1.03294499107E-03 1.07440461449E-03 1.11751369109E-03 1.16233694434E-03 1.20894158205E-03 1.25739738832E-03 1.30777681866E-03 1.36015509840E-03 1.41461032450E-03 1.47122357085E-03 1.53007899709E-03 1.59126396125E-03 1.65486913611E-03 1.72098862946E-03 1.78972010842E-03 1.86116492792E-03 1.93542826332E-03 2.01261924757E-03 2.09285111266E-03 2.17624133580E-03 2.26291179030E-03 2.35298890127E-03 2.44660380626E-03 2.54389252106E-03 2.64499611064E-03 2.75006086549E-03 2.85923848332E-03 2.97268625645E-03 3.09056726486E-03 3.21305057503E-03 3.34031144478E-03 3.47253153416E-03 3.60989912252E-03 3.75260933190E-03 3.90086435680E-03 4.05487370055E-03 4.21485441820E-03 4.38103136625E-03 4.55363745914E-03 4.73291393274E-03 4.91911061474E-03 5.11248620225E-03 5.31330854645E-03 5.52185494454E-03 5.73841243897E-03 5.96327812388E-03 6.19675945903E-03 6.43917459104E-03 6.69085268195E-03 6.95213424525E-03 7.22337148914E-03 7.50492866721E-03 7.79718243623E-03 8.10052222116E-03 8.41535058720E-03 8.74208361878E-03 9.08115130521E-03 9.43299793307E-03 9.79808248484E-03 1.01768790437E-02 1.05698772043E-02 1.09775824889E-02 1.14005167685E-02 1.18392186894E-02 1.22942441038E-02 1.27661665037E-02 1.32555774592E-02 1.37630870587E-02 1.42893243517E-02 1.48349377926E-02 1.54005956859E-02 1.59869866302E-02 1.65948199620E-02 1.72248261969E-02 1.78777574679E-02 1.85543879598E-02 1.92555143374E-02 1.99819561675E-02 2.07345563329E-02 2.15141814356E-02 2.23217221907E-02 2.31580938049E-02 2.40242363423E-02 2.49211150721E-02 2.58497207977E-02 2.68110701652E-02 2.78062059475E-02 2.88361973037E-02 2.99021400088E-02 3.10051566528E-02 3.21463968052E-02 3.33270371420E-02 3.45482815324E-02 3.58113610809E-02 3.71175341220E-02 3.84680861632E-02 3.98643297721E-02 4.13076044044E-02 4.27992761673E-02 4.43407375135E-02 4.59334068634E-02 4.75787281463E-02 4.92781702602E-02 5.10332264403E-02 5.28454135341E-02 5.47162711747E-02 5.66473608481E-02 5.86402648465E-02 6.06965851028E-02 6.28179418980E-02 6.50059724361E-02 6.72623292776E-02 6.95886786265E-02 7.19866984614E-02 7.44580765039E-02 7.70045080163E-02 7.96276934214E-02 8.23293357347E-02 8.51111378030E-02 8.79747993384E-02 9.09220137426E-02 9.39544647105E-02 9.70738226062E-02 1.00281740602E-01 1.03579850575E-01 1.06969758747E-01 1.10453041069E-01 1.14031238332E-01 1.17705851008E-01 1.21478333803E-01 1.25350089921E-01 1.29322465037E-01 1.33396740960E-01 1.37574128998E-01 1.41855763006E-01 1.46242692119E-01 1.50735873171E-01 1.55336162791E-01 1.60044309181E-01 1.64860943569E-01 1.69786571355E-01 1.74821562929E-01 1.79966144184E-01 1.85220386734E-01 1.90584197818E-01 1.96057309938E-01 2.01639270212E-01 2.07329429475E-01 2.13126931135E-01 2.19030699813E-01 2.25039429778E-01 2.31151573216E-01 2.37365328349E-01 2.43678627442E-01 2.50089124735E-01 2.56594184332E-01 2.63190868098E-01 2.69875923600E-01 2.76645772150E-01 2.83496497008E-01 2.90423831785E-01 2.97423149135E-01 3.04489449780E-01 3.11617351954E-01 3.18801081339E-01 3.26034461565E-01 3.33310905377E-01 3.40623406540E-01 3.47964532583E-01 3.55326418491E-01 3.62700761425E-01 3.70078816591E-01 3.77451394370E-01 3.84808858810E-01 3.92141127600E-01 3.99437673644E-01 4.06687528363E-01 4.13879286828E-01 4.21001114854E-01 4.28040758189E-01 4.34985553890E-01 4.41822444030E-01 4.48537991837E-01 4.55118400382E-01 4.61549533921E-01 4.67816941987E-01 4.73905886331E-01 4.79801370793E-01 4.85488174171E-01 4.90950886156E-01 4.96173946377E-01 5.01141686584E-01 5.05838375997E-01 5.10248269798E-01 5.14355660765E-01 5.18144933978E-01 5.21600624554E-01 5.24707478289E-01 5.27450515107E-01 5.29815095155E-01 5.31786987361E-01 5.33352440251E-01 5.34498254777E-01 5.35211858875E-01 5.35481383447E-01 5.35295739413E-01 5.34644695460E-01 5.33518956066E-01 5.31910239352E-01 5.29811354267E-01 5.27216276616E-01 5.24120223353E-01 5.20519724588E-01 5.16412692696E-01 5.11798487915E-01 5.06677979778E-01 5.01053603739E-01 4.94929412320E-01 4.88311120113E-01 4.81206141962E-01 4.73623623676E-01 4.65574464624E-01 4.57071331578E-01 4.48128663230E-01 4.38762664807E-01 4.28991292280E-01 4.18834225708E-01 4.08312831323E-01 3.97450112013E-01 3.86270645983E-01 3.74800513388E-01 3.63067210917E-01 3.51099554305E-01 3.38927568949E-01 3.26582368849E-01 3.14096024247E-01 3.01501418440E-01 2.88832094371E-01 2.76122091726E-01 2.63405775381E-01 2.50717656179E-01 2.38092205109E-01 2.25563662113E-01 2.13165840810E-01 2.00931930568E-01 1.88894297429E-01 1.77084285467E-01 1.65532020256E-01 1.54266216167E-01 1.43313989270E-01 1.32700677632E-01 1.22449670860E-01 1.12582250689E-01 1.03117444445E-01 9.40718931525E-02 8.54597360251E-02 7.72925129950E-02 6.95790868625E-02 6.23255865275E-02 5.55353726456E-02 4.92090268927E-02 4.33443658509E-02 3.79364803308E-02 3.29778007163E-02 2.84581886694E-02 2.43650552520E-02 2.06835052111E-02 1.73965068387E-02 1.44850864460E-02 1.19285461016E-02 9.70470285744E-03 7.79014724749E-03 6.16051838079E-03 4.79079248413E-03 3.65558127814E-03 2.72943611285E-03 1.98715335471E-03 1.40407612436E-03 9.56387149483E-04 6.21387240820E-04 3.77753740079E-04 2.05773248870E-04 8.84113644414E-05 1.37113267523E-05 -2.83357181211E-05 -4.66519364059E-05 -4.89876346667E-05 -4.18520754927E-05 -3.04624843474E-05 -1.87134802270E-05 -9.16918685436E-06 -3.08030349134E-06 -4.28435031757E-07 -6.49923852014E-18 -1.87697141481E-18 7.12144964948E-18 -7.03195919572E-18 1.17419196089E-17 -4.37860483015E-18 2.22549777090E-17 3.86388776362E-18 2.60344254519E-18 4.24121994815E-18 6.70048866923E-19 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 4 4 1 i j (l(j)) 3.56453544260E-01 Q_int 2.54784619199E-13 2.65182574404E-13 2.76004878066E-13 2.87268848164E-13 2.98992509438E-13 3.11194622231E-13 3.23894712508E-13 3.37113103105E-13 3.50870946247E-13 3.65190257397E-13 3.80093950485E-13 3.95605874577E-13 4.11750852035E-13 4.28554718240E-13 4.46044362935E-13 4.64247773252E-13 4.83194078500E-13 5.02913596775E-13 5.23437883477E-13 5.44799781805E-13 5.67033475313E-13 5.90174542610E-13 6.14260014296E-13 6.39328432214E-13 6.65419911130E-13 6.92576202921E-13 7.20840763390E-13 7.50258821800E-13 7.80877453256E-13 8.12745654030E-13 8.45914419968E-13 8.80436828093E-13 9.16368121539E-13 9.53765797952E-13 9.92689701499E-13 1.03320211863E-12 1.07536787775E-12 1.11925445295E-12 1.16493207199E-12 1.21247382870E-12 1.26195579987E-12 1.31345716709E-12 1.36706034337E-12 1.42285110506E-12 1.48091872913E-12 1.54135613596E-12 1.60426003811E-12 1.66973109505E-12 1.73787407420E-12 1.80879801864E-12 1.88261642157E-12 1.95944740791E-12 2.03941392336E-12 2.12264393111E-12 2.20927061662E-12 2.29943260072E-12 2.39327416147E-12 2.49094546502E-12 2.59260280589E-12 2.69840885709E-12 2.80853293042E-12 2.92315124742E-12 3.04244722134E-12 3.16661175065E-12 3.29584352452E-12 3.43034934075E-12 3.57034443669E-12 3.71605283368E-12 3.86770769552E-12 4.02555170156E-12 4.18983743507E-12 4.36082778741E-12 4.53879637869E-12 4.72402799564E-12 4.91681904733E-12 5.11747803946E-12 5.32632606806E-12 5.54369733328E-12 5.76993967419E-12 6.00541512540E-12 6.25050049638E-12 6.50558797442E-12 6.77108575222E-12 7.04741868107E-12 7.33502895073E-12 7.63437679696E-12 7.94594123804E-12 8.27022084128E-12 8.60773452080E-12 8.95902236794E-12 9.32464651547E-12 9.70519203715E-12 1.01012678839E-11 1.05135078584E-11 1.09425716290E-11 1.13891457856E-11 1.18539449383E-11 1.23377128607E-11 1.28412236803E-11 1.33652831172E-11 1.39107297733E-11 1.44784364744E-11 1.50693116666E-11 1.56843008705E-11 1.63243881936E-11 1.69905979056E-11 1.76839960770E-11 1.84056922852E-11 1.91568413901E-11 1.99386453821E-11 2.07523553053E-11 2.15992732596E-11 2.24807544841E-11 2.33982095261E-11 2.43531064980E-11 2.53469734262E-11 2.63814006971E-11 2.74580436012E-11 2.85786249823E-11 2.97449379940E-11 3.09588489696E-11 3.22223004081E-11 3.35373140828E-11 3.49059942764E-11 3.63305311483E-11 3.78132042392E-11 3.93563861187E-11 4.09625461820E-11 4.26342546012E-11 4.43741864382E-11 4.61851259251E-11 4.80699709196E-11 5.00317375420E-11 5.20735650014E-11 5.41987206193E-11 5.64106050574E-11 5.87127577599E-11 6.11088626165E-11 6.36027538576E-11 6.61984221897E-11 6.89000211814E-11 7.17118739093E-11 7.46384798760E-11 7.76845222099E-11 8.08548751592E-11 8.41546118910E-11 8.75890126098E-11 9.11635730062E-11 9.48840130510E-11 9.87562861483E-11 1.02786588661E-10 1.06981369828E-10 1.11347342082E-10 1.15891491789E-10 1.20621090433E-10 1.25543706246E-10 1.30667216320E-10 1.35999819213E-10 1.41550048067E-10 1.47326784260E-10 1.53339271622E-10 1.59597131221E-10 1.66110376765E-10 1.72889430617E-10 1.79945140480E-10 1.87288796749E-10 1.94932150581E-10 2.02887432697E-10 2.11167372951E-10 2.19785220703E-10 2.28754766018E-10 2.38090361729E-10 2.47806946408E-10 2.57920068269E-10 2.68445910043E-10 2.79401314876E-10 2.90803813279E-10 3.02671651178E-10 3.15023819112E-10 3.27880082616E-10 3.41261013852E-10 3.55188024524E-10 3.69683400142E-10 3.84770335678E-10 4.00472972680E-10 4.16816437903E-10 4.33826883516E-10 4.51531528943E-10 4.69958704419E-10 4.89137896322E-10 5.09099794352E-10 5.29876340639E-10 5.51500780851E-10 5.74007717391E-10 5.97433164762E-10 6.21814607195E-10 6.47191058626E-10 6.73603125119E-10 7.01093069840E-10 7.29704880680E-10 7.59484340641E-10 7.90479101085E-10 8.22738757985E-10 8.56314931280E-10 8.91261347464E-10 9.27633925559E-10 9.65490866579E-10 1.00489274666E-09 1.04590261399E-09 1.08858608966E-09 1.13301147269E-09 1.17924984931E-09 1.22737520667E-09 1.27746455124E-09 1.32959803202E-09 1.38385906879E-09 1.44033448555E-09 1.49911464947E-09 1.56029361545E-09 1.62396927663E-09 1.69024352102E-09 1.75922239449E-09 1.83101627046E-09 1.90574002649E-09 1.98351322809E-09 2.06446032000E-09 2.14871082532E-09 2.23639955271E-09 2.32766681211E-09 2.42265863921E-09 2.52152702907E-09 2.62443017938E-09 2.73153274346E-09 2.84300609377E-09 2.95902859608E-09 3.07978589478E-09 3.20547120997E-09 3.33628564653E-09 3.47243851592E-09 3.61414767099E-09 3.76163985455E-09 3.91515106216E-09 4.07492691960E-09 4.24122307595E-09 4.41430561246E-09 4.59445146836E-09 4.78194888383E-09 4.97709786115E-09 5.18021064467E-09 5.39161222032E-09 5.61164083553E-09 5.84064854034E-09 6.07900175061E-09 6.32708183421E-09 6.58528572110E-09 6.85402653832E-09 7.13373427090E-09 7.42485644971E-09 7.72785886739E-09 8.04322632346E-09 8.37146339990E-09 8.71309526829E-09 9.06866852992E-09 9.43875209019E-09 9.82393806863E-09 1.02248427461E-08 1.06421075507E-08 1.10764000836E-08 1.15284151872E-08 1.19988760564E-08 1.24885353955E-08 1.29981766222E-08 1.35286151207E-08 1.40806995461E-08 1.46553131815E-08 1.52533753512E-08 1.58758428910E-08 1.65237116786E-08 1.71980182268E-08 1.78998413407E-08 1.86303038440E-08 1.93905743743E-08 2.01818692525E-08 2.10054544281E-08 2.18626475041E-08 2.27548198439E-08 2.36833987651E-08 2.46498698221E-08 2.56557791818E-08 2.67027360965E-08 2.77924154775E-08 2.89265605741E-08 3.01069857606E-08 3.13355794390E-08 3.26143070578E-08 3.39452142562E-08 3.53304301345E-08 3.67721706594E-08 3.82727422074E-08 3.98345452529E-08 4.14600782066E-08 4.31519414110E-08 4.49128412979E-08 4.67455947165E-08 4.86531334371E-08 5.06385088388E-08 5.27048967890E-08 5.48556027206E-08 5.70940669175E-08 5.94238700148E-08 6.18487387237E-08 6.43725517897E-08 6.69993461939E-08 6.97333236068E-08 7.25788571060E-08 7.55404981668E-08 7.86229839386E-08 8.18312448180E-08 8.51704123300E-08 8.86458273312E-08 9.22630485475E-08 9.60278614588E-08 9.99462875478E-08 1.04024593924E-07 1.08269303341E-07 1.12687204622E-07 1.17285363511E-07 1.22071133965E-07 1.27052169908E-07 1.32236437461E-07 1.37632227676E-07 1.43248169784E-07 1.49093244985E-07 1.55176800803E-07 1.61508566018E-07 1.68098666213E-07 1.74957639959E-07 1.82096455646E-07 1.89526529012E-07 1.97259741383E-07 2.05308458652E-07 2.13685551040E-07 2.22404413650E-07 2.31478987876E-07 2.40923783663E-07 2.50753902693E-07 2.60985062504E-07 2.71633621598E-07 2.82716605566E-07 2.94251734285E-07 3.06257450215E-07 3.18752947855E-07 3.31758204395E-07 3.45294011617E-07 3.59382009101E-07 3.74044718772E-07 3.89305580868E-07 4.05188991361E-07 4.21720340909E-07 4.38926055391E-07 4.56833638097E-07 4.75471713629E-07 4.94870073594E-07 5.15059724163E-07 5.36072935551E-07 5.57943293529E-07 5.80705753021E-07 6.04396693888E-07 6.29053978982E-07 6.54717014563E-07 6.81426813175E-07 7.09226059081E-07 7.38159176364E-07 7.68272399790E-07 7.99613848572E-07 8.32233603115E-07 8.66183784901E-07 9.01518639615E-07 9.38294623652E-07 9.76570494154E-07 1.01640740269E-06 1.05786899278E-06 1.10102150134E-06 1.14593386429E-06 1.19267782645E-06 1.24132805587E-06 1.29196226289E-06 1.34466132394E-06 1.39950941045E-06 1.45659412295E-06 1.51600663069E-06 1.57784181684E-06 1.64219842964E-06 1.70917923975E-06 1.77889120389E-06 1.85144563517E-06 1.92695838039E-06 2.00555000447E-06 2.08734598241E-06 2.17247689904E-06 2.26107865688E-06 2.35329269244E-06 2.44926620134E-06 2.54915237248E-06 2.65311063182E-06 2.76130689601E-06 2.87391383628E-06 2.99111115310E-06 3.11308586198E-06 3.24003259079E-06 3.37215388927E-06 3.50966055098E-06 3.65277194835E-06 3.80171638136E-06 3.95673144030E-06 4.11806438326E-06 4.28597252891E-06 4.46072366525E-06 4.64259647487E-06 4.83188097746E-06 5.02887899028E-06 5.23390460721E-06 5.44728469731E-06 5.66935942347E-06 5.90048278213E-06 6.14102316483E-06 6.39136394245E-06 6.65190407320E-06 6.92305873508E-06 7.20525998403E-06 7.49895743870E-06 7.80461899282E-06 8.12273155649E-06 8.45380182737E-06 8.79835709310E-06 9.15694606605E-06 9.53013975194E-06 9.91853235342E-06 1.03227422102E-05 1.07434127772E-05 1.11812136421E-05 1.16368415839E-05 1.21110216745E-05 1.26045084242E-05 1.31180869741E-05 1.36525743360E-05 1.42088206823E-05 1.47877106886E-05 1.53901649292E-05 1.60171413300E-05 1.66696366795E-05 1.73486881999E-05 1.80553751827E-05 1.87908206893E-05 1.95561933203E-05 2.03527090556E-05 2.11816331691E-05 2.20442822196E-05 2.29420261227E-05 2.38762903046E-05 2.48485579438E-05 2.58603723014E-05 2.69133391462E-05 2.80091292762E-05 2.91494811413E-05 3.03362035716E-05 3.15711786146E-05 3.28563644859E-05 3.41937986389E-05 3.55856009560E-05 3.70339770689E-05 3.85412218103E-05 4.01097228048E-05 4.17419642027E-05 4.34405305623E-05 4.52081108887E-05 4.70475028321E-05 4.89616170549E-05 5.09534817718E-05 5.30262474717E-05 5.51831918267E-05 5.74277247975E-05 5.97633939411E-05 6.21938899299E-05 6.47230522902E-05 6.73548753681E-05 7.00935145330E-05 7.29432926265E-05 7.59087066675E-05 7.89944348223E-05 8.22053436517E-05 8.55464956438E-05 8.90231570454E-05 9.26408060031E-05 9.64051410248E-05 1.00322089777E-04 1.04397818226E-04 1.08638740144E-04 1.13051526985E-04 1.17643118151E-04 1.22420731664E-04 1.27391875253E-04 1.32564357881E-04 1.37946301720E-04 1.43546154597E-04 1.49372702930E-04 1.55435085163E-04 1.61742805736E-04 1.68305749592E-04 1.75134197255E-04 1.82238840491E-04 1.89630798586E-04 1.97321635250E-04 2.05323376182E-04 2.13648527317E-04 2.22310093777E-04 2.31321599558E-04 2.40697107982E-04 2.50451242934E-04 2.60599210923E-04 2.71156823988E-04 2.82140523495E-04 2.93567404836E-04 3.05455243092E-04 3.17822519667E-04 3.30688449952E-04 3.44073012036E-04 3.57996976527E-04 3.72481937498E-04 3.87550344620E-04 4.03225536513E-04 4.19531775360E-04 4.36494282840E-04 4.54139277416E-04 4.72494013029E-04 4.91586819258E-04 5.11447142986E-04 5.32105591632E-04 5.53593978005E-04 5.75945366840E-04 5.99194123064E-04 6.23375961871E-04 6.48528000653E-04 6.74688812860E-04 7.01898483857E-04 7.30198668843E-04 7.59632652910E-04 7.90245413303E-04 8.22083683974E-04 8.55196022491E-04 8.89632879398E-04 9.25446670092E-04 9.62691849318E-04 1.00142498836E-03 1.04170485501E-03 1.08359249644E-03 1.12715132501E-03 1.17244720722E-03 1.21954855572E-03 1.26852642471E-03 1.31945460865E-03 1.37240974448E-03 1.42747141743E-03 1.48472227055E-03 1.54424811804E-03 1.60613806259E-03 1.67048461667E-03 1.73738382814E-03 1.80693541006E-03 1.87924287505E-03 1.95441367410E-03 2.03255934022E-03 2.11379563683E-03 2.19824271120E-03 2.28602525297E-03 2.37727265795E-03 2.47211919738E-03 2.57070419263E-03 2.67317219575E-03 2.77967317577E-03 2.89036271108E-03 3.00540218791E-03 3.12495900520E-03 3.24920678587E-03 3.37832559481E-03 3.51250216352E-03 3.65193012186E-03 3.79681023676E-03 3.94735065826E-03 4.10376717293E-03 4.26628346484E-03 4.43513138433E-03 4.61055122449E-03 4.79279200579E-03 4.98211176875E-03 5.17877787504E-03 5.38306731680E-03 5.59526703470E-03 5.81567424459E-03 6.04459677288E-03 6.28235340093E-03 6.52927421834E-03 6.78570098535E-03 7.05198750438E-03 7.32850000079E-03 7.61561751293E-03 7.91373229145E-03 8.22325020795E-03 8.54459117297E-03 8.87818956327E-03 9.22449465839E-03 9.58397108638E-03 9.95709927870E-03 1.03443759341E-02 1.07463144915E-02 1.11634456112E-02 1.15963176650E-02 1.20454972345E-02 1.25115696171E-02 1.29951393399E-02 1.34968306810E-02 1.40172881974E-02 1.45571772594E-02 1.51171845910E-02 1.56980188160E-02 1.63004110079E-02 1.69251152448E-02 1.75729091670E-02 1.82445945373E-02 1.89409978026E-02 1.96629706563E-02 2.04113906001E-02 2.11871615040E-02 2.19912141633E-02 2.28245068518E-02 2.36880258685E-02 2.45827860774E-02 2.55098314382E-02 2.64702355262E-02 2.74651020393E-02 2.84955652899E-02 2.95627906805E-02 3.06679751590E-02 3.18123476526E-02 3.29971694765E-02 3.42237347157E-02 3.54933705763E-02 3.68074377022E-02 3.81673304560E-02 3.95744771579E-02 4.10303402815E-02 4.25364165997E-02 4.40942372792E-02 4.57053679170E-02 4.73714085156E-02 4.90939933913E-02 5.08747910109E-02 5.27155037510E-02 5.46178675743E-02 5.65836516180E-02 5.86146576860E-02 6.07127196411E-02 6.28797026883E-02 6.51175025435E-02 6.74280444799E-02 6.98132822447E-02 7.22751968386E-02 7.48157951490E-02 7.74371084302E-02 8.01411906206E-02 8.29301164890E-02 8.58059796003E-02 8.87708900913E-02 9.18269722482E-02 9.49763618738E-02 9.82212034369E-02 1.01563646992E-01 1.05005844861E-01 1.08549948062E-01 1.12198102481E-01 1.15952444773E-01 1.19815097979E-01 1.23788166853E-01 1.27873732887E-01 1.32073849021E-01 1.36390534033E-01 1.40825766591E-01 1.45381478971E-01 1.50059550411E-01 1.54861800113E-01 1.59789979874E-01 1.64845766334E-01 1.70030752847E-01 1.75346440955E-01 1.80794231470E-01 1.86375415153E-01 1.92091162992E-01 1.97942516066E-01 2.03930375014E-01 2.10055489092E-01 2.16318444825E-01 2.22719654266E-01 2.29259342863E-01 2.35937536938E-01 2.42754050801E-01 2.49708473502E-01 2.56800155241E-01 2.64028193464E-01 2.71391418648E-01 2.78888379823E-01 2.86517329842E-01 2.94276210454E-01 3.02162637185E-01 3.10173884106E-01 3.18306868508E-01 3.26558135535E-01 3.34923842855E-01 3.43399745392E-01 3.51981180219E-01 3.60663051660E-01 3.69439816688E-01 3.78305470695E-01 3.87253533723E-01 3.96277037255E-01 4.05368511654E-01 4.14519974358E-01 4.23722918948E-01 4.32968305199E-01 4.42246550227E-01 4.51547520882E-01 4.60860527487E-01 4.70174319090E-01 4.79477080346E-01 4.88756430192E-01 4.97999422444E-01 5.07192548488E-01 5.16321742200E-01 5.25372387264E-01 5.34329327029E-01 5.43176877071E-01 5.51898840606E-01 5.60478526912E-01 5.68898772895E-01 5.77141967946E-01 5.85190082229E-01 5.93024698509E-01 6.00627047656E-01 6.07978047909E-01 6.15058348000E-01 6.21848374207E-01 6.28328381395E-01 6.34478508080E-01 6.40278835513E-01 6.45709450805E-01 6.50750514018E-01 6.55382329181E-01 6.59585419117E-01 6.63340603956E-01 6.66629083160E-01 6.69432520868E-01 6.71733134292E-01 6.73513784908E-01 6.74758072084E-01 6.75450428800E-01 6.75576219026E-01 6.75121836302E-01 6.74074803010E-01 6.72423869802E-01 6.70159114557E-01 6.67272040264E-01 6.63755671126E-01 6.59604646169E-01 6.54815309616E-01 6.49385797223E-01 6.43316117767E-01 6.36608228852E-01 6.29266106180E-01 6.21295805409E-01 6.12705515749E-01 6.03505604417E-01 5.93708651110E-01 5.83329471662E-01 5.72385130089E-01 5.60894938278E-01 5.48880442598E-01 5.36365396819E-01 5.23375720757E-01 5.09939444175E-01 4.96086635562E-01 4.81849315510E-01 4.67261354534E-01 4.52358355315E-01 4.37177519469E-01 4.21757499088E-01 4.06138233480E-01 3.90360771652E-01 3.74467081270E-01 3.58499844986E-01 3.42502245198E-01 3.26517738440E-01 3.10589820824E-01 2.94761786037E-01 2.79076477617E-01 2.63576037322E-01 2.48301651566E-01 2.33293298005E-01 2.18589494450E-01 2.04227052378E-01 1.90240837385E-01 1.76663538941E-01 1.63525451872E-01 1.50854271961E-01 1.38674908042E-01 1.27009312924E-01 1.15876335391E-01 1.05291595420E-01 9.52673846336E-02 8.58125938339E-02 7.69326692730E-02 6.86295991004E-02 6.09019311649E-02 5.37448230695E-02 4.71501250615E-02 4.11064959870E-02 3.55995521639E-02 3.06120486088E-02 2.61240916116E-02 2.21133811763E-02 1.85554813448E-02 1.54241158943E-02 1.26914863577E-02 1.03286087595E-02 8.30566490610E-03 6.59236352339E-03 5.15830601477E-03 3.97335113550E-03 3.00797246407E-03 2.23360222156E-03 1.62295476998E-03 1.15032303648E-03 7.91841189201E-04 5.25707158860E-04 3.32359082010E-04 1.95216209465E-04 1.02174802917E-04 4.30745253408E-05 9.03294249024E-06 -7.51810865671E-06 -1.28202221622E-05 -1.18018633858E-05 -8.11897298235E-06 -4.22387641335E-06 -1.46331464495E-06 -2.06039868654E-07 -2.41482311957E-19 4.62734689275E-18 -9.27747991207E-19 -1.32076393575E-18 1.50375816197E-18 -1.54794539749E-18 9.94957714309E-18 3.60867120653E-19 -2.97656047665E-19 -5.14181040611E-19 2.64002446531E-19 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2S 0 2.00 Wavefunction 5.65188379778E-04 5.70868616623E-04 5.76605940773E-04 5.82400925965E-04 5.88254151699E-04 5.94166203304E-04 6.00137671987E-04 6.06169154900E-04 6.12261255194E-04 6.18414582084E-04 6.24629750906E-04 6.30907383181E-04 6.37248106677E-04 6.43652555468E-04 6.50121370006E-04 6.56655197173E-04 6.63254690358E-04 6.69920509514E-04 6.76653321227E-04 6.83453798781E-04 6.90322622229E-04 6.97260478457E-04 7.04268061254E-04 7.11346071383E-04 7.18495216650E-04 7.25716211972E-04 7.33009779453E-04 7.40376648453E-04 7.47817555665E-04 7.55333245182E-04 7.62924468578E-04 7.70591984979E-04 7.78336561140E-04 7.86158971524E-04 7.94059998375E-04 8.02040431800E-04 8.10101069846E-04 8.18242718582E-04 8.26466192175E-04 8.34772312977E-04 8.43161911605E-04 8.51635827021E-04 8.60194906622E-04 8.68840006319E-04 8.77571990626E-04 8.86391732746E-04 8.95300114655E-04 9.04298027196E-04 9.13386370165E-04 9.22566052398E-04 9.31837991868E-04 9.41203115772E-04 9.50662360626E-04 9.60216672358E-04 9.69867006402E-04 9.79614327796E-04 9.89459611275E-04 9.99403841370E-04 1.00944801251E-03 1.01959312911E-03 1.02984020568E-03 1.04019026695E-03 1.05064434791E-03 1.06120349398E-03 1.07186876107E-03 1.08264121572E-03 1.09352193517E-03 1.10451200749E-03 1.11561253170E-03 1.12682461786E-03 1.13814938716E-03 1.14958797209E-03 1.16114151651E-03 1.17281117577E-03 1.18459811685E-03 1.19650351844E-03 1.20852857107E-03 1.22067447726E-03 1.23294245160E-03 1.24533372088E-03 1.25784952424E-03 1.27049111325E-03 1.28325975206E-03 1.29615671756E-03 1.30918329942E-03 1.32234080031E-03 1.33563053598E-03 1.34905383540E-03 1.36261204090E-03 1.37630650830E-03 1.39013860704E-03 1.40410972032E-03 1.41822124527E-03 1.43247459302E-03 1.44687118891E-03 1.46141247260E-03 1.47609989820E-03 1.49093493446E-03 1.50591906488E-03 1.52105378786E-03 1.53634061688E-03 1.55178108060E-03 1.56737672306E-03 1.58312910384E-03 1.59903979815E-03 1.61511039705E-03 1.63134250761E-03 1.64773775301E-03 1.66429777278E-03 1.68102422291E-03 1.69791877603E-03 1.71498312159E-03 1.73221896601E-03 1.74962803286E-03 1.76721206303E-03 1.78497281491E-03 1.80291206457E-03 1.82103160592E-03 1.83933325088E-03 1.85781882962E-03 1.87649019066E-03 1.89534920113E-03 1.91439774691E-03 1.93363773283E-03 1.95307108288E-03 1.97269974035E-03 1.99252566810E-03 2.01255084870E-03 2.03277728463E-03 2.05320699851E-03 2.07384203329E-03 2.09468445244E-03 2.11573634018E-03 2.13699980165E-03 2.15847696318E-03 2.18016997244E-03 2.20208099871E-03 2.22421223304E-03 2.24656588853E-03 2.26914420049E-03 2.29194942672E-03 2.31498384770E-03 2.33824976682E-03 2.36174951063E-03 2.38548542906E-03 2.40945989564E-03 2.43367530777E-03 2.45813408694E-03 2.48283867897E-03 2.50779155425E-03 2.53299520803E-03 2.55845216059E-03 2.58416495757E-03 2.61013617019E-03 2.63636839548E-03 2.66286425661E-03 2.68962640307E-03 2.71665751102E-03 2.74396028347E-03 2.77153745063E-03 2.79939177011E-03 2.82752602727E-03 2.85594303543E-03 2.88464563620E-03 2.91363669974E-03 2.94291912505E-03 2.97249584027E-03 3.00236980296E-03 3.03254400039E-03 3.06302144987E-03 3.09380519903E-03 3.12489832610E-03 3.15630394027E-03 3.18802518196E-03 3.22006522316E-03 3.25242726773E-03 3.28511455171E-03 3.31813034369E-03 3.35147794508E-03 3.38516069046E-03 3.41918194796E-03 3.45354511950E-03 3.48825364123E-03 3.52331098381E-03 3.55872065277E-03 3.59448618888E-03 3.63061116847E-03 3.66709920384E-03 3.70395394356E-03 3.74117907287E-03 3.77877831405E-03 3.81675542677E-03 3.85511420849E-03 3.89385849482E-03 3.93299215991E-03 3.97251911686E-03 4.01244331806E-03 4.05276875564E-03 4.09349946183E-03 4.13463950938E-03 4.17619301196E-03 4.21816412458E-03 4.26055704399E-03 4.30337600914E-03 4.34662530153E-03 4.39030924571E-03 4.43443220967E-03 4.47899860530E-03 4.52401288880E-03 4.56947956116E-03 4.61540316860E-03 4.66178830300E-03 4.70863960240E-03 4.75596175141E-03 4.80375948175E-03 4.85203757265E-03 4.90080085137E-03 4.95005419367E-03 4.99980252430E-03 5.05005081748E-03 5.10080409743E-03 5.15206743882E-03 5.20384596733E-03 5.25614486012E-03 5.30896934637E-03 5.36232470781E-03 5.41621627922E-03 5.47064944897E-03 5.52562965959E-03 5.58116240827E-03 5.63725324743E-03 5.69390778528E-03 5.75113168636E-03 5.80893067213E-03 5.86731052152E-03 5.92627707151E-03 5.98583621775E-03 6.04599391508E-03 6.10675617818E-03 6.16812908215E-03 6.23011876312E-03 6.29273141886E-03 6.35597330939E-03 6.41985075764E-03 6.48437015003E-03 6.54953793715E-03 6.61536063437E-03 6.68184482253E-03 6.74899714855E-03 6.81682432614E-03 6.88533313644E-03 6.95453042868E-03 7.02442312093E-03 7.09501820071E-03 7.16632272576E-03 7.23834382466E-03 7.31108869765E-03 7.38456461723E-03 7.45877892899E-03 7.53373905228E-03 7.60945248095E-03 7.68592678413E-03 7.76316960698E-03 7.84118867142E-03 7.91999177692E-03 7.99958680131E-03 8.07998170149E-03 8.16118451430E-03 8.24320335728E-03 8.32604642948E-03 8.40972201230E-03 8.49423847029E-03 8.57960425200E-03 8.66582789081E-03 8.75291800579E-03 8.84088330257E-03 8.92973257417E-03 9.01947470190E-03 9.11011865628E-03 9.20167349785E-03 9.29414837816E-03 9.38755254061E-03 9.48189532142E-03 9.57718615055E-03 9.67343455261E-03 9.77065014784E-03 9.86884265306E-03 9.96802188265E-03 1.00681977495E-02 1.01693802659E-02 1.02715795449E-02 1.03748058009E-02 1.04790693507E-02 1.05843806149E-02 1.06907501185E-02 1.07981884924E-02 1.09067064738E-02 1.10163149080E-02 1.11270247491E-02 1.12388470608E-02 1.13517930184E-02 1.14658739088E-02 1.15811011324E-02 1.16974862042E-02 1.18150407543E-02 1.19337765298E-02 1.20537053956E-02 1.21748393356E-02 1.22971904540E-02 1.24207709764E-02 1.25455932511E-02 1.26716697502E-02 1.27990130708E-02 1.29276359366E-02 1.30575511989E-02 1.31887718377E-02 1.33213109634E-02 1.34551818178E-02 1.35903977754E-02 1.37269723450E-02 1.38649191709E-02 1.40042520339E-02 1.41449848534E-02 1.42871316880E-02 1.44307067376E-02 1.45757243442E-02 1.47221989937E-02 1.48701453171E-02 1.50195780923E-02 1.51705122450E-02 1.53229628509E-02 1.54769451365E-02 1.56324744809E-02 1.57895664175E-02 1.59482366353E-02 1.61085009805E-02 1.62703754579E-02 1.64338762330E-02 1.65990196330E-02 1.67658221487E-02 1.69343004362E-02 1.71044713183E-02 1.72763517863E-02 1.74499590019E-02 1.76253102984E-02 1.78024231827E-02 1.79813153372E-02 1.81620046211E-02 1.83445090726E-02 1.85288469103E-02 1.87150365354E-02 1.89030965329E-02 1.90930456742E-02 1.92849029183E-02 1.94786874141E-02 1.96744185019E-02 1.98721157157E-02 2.00717987847E-02 2.02734876357E-02 2.04772023945E-02 2.06829633886E-02 2.08907911483E-02 2.11007064095E-02 2.13127301154E-02 2.15268834184E-02 2.17431876824E-02 2.19616644850E-02 2.21823356192E-02 2.24052230959E-02 2.26303491459E-02 2.28577362221E-02 2.30874070015E-02 2.33193843879E-02 2.35536915137E-02 2.37903517421E-02 2.40293886698E-02 2.42708261290E-02 2.45146881896E-02 2.47609991620E-02 2.50097835988E-02 2.52610662980E-02 2.55148723047E-02 2.57712269137E-02 2.60301556723E-02 2.62916843824E-02 2.65558391031E-02 2.68226461533E-02 2.70921321141E-02 2.73643238315E-02 2.76392484191E-02 2.79169332603E-02 2.81974060113E-02 2.84806946038E-02 2.87668272474E-02 2.90558324326E-02 2.93477389332E-02 2.96425758095E-02 2.99403724108E-02 3.02411583782E-02 3.05449636475E-02 3.08518184523E-02 3.11617533263E-02 3.14747991069E-02 3.17909869378E-02 3.21103482719E-02 3.24329148743E-02 3.27587188257E-02 3.30877925249E-02 3.34201686923E-02 3.37558803728E-02 3.40949609390E-02 3.44374440943E-02 3.47833638761E-02 3.51327546591E-02 3.54856511585E-02 3.58420884333E-02 3.62021018892E-02 3.65657272828E-02 3.69330007240E-02 3.73039586800E-02 3.76786379786E-02 3.80570758113E-02 3.84393097374E-02 3.88253776868E-02 3.92153179641E-02 3.96091692517E-02 4.00069706140E-02 4.04087615001E-02 4.08145817485E-02 4.12244715899E-02 4.16384716514E-02 4.20566229600E-02 4.24789669467E-02 4.29055454499E-02 4.33364007193E-02 4.37715754201E-02 4.42111126364E-02 4.46550558755E-02 4.51034490716E-02 4.55563365901E-02 4.60137632311E-02 4.64757742340E-02 4.69424152811E-02 4.74137325022E-02 4.78897724781E-02 4.83705822453E-02 4.88562093001E-02 4.93467016025E-02 4.98421075807E-02 5.03424761356E-02 5.08478566447E-02 5.13582989666E-02 5.18738534455E-02 5.23945709155E-02 5.29205027050E-02 5.34517006412E-02 5.39882170546E-02 5.45301047836E-02 5.50774171790E-02 5.56302081084E-02 5.61885319611E-02 5.67524436526E-02 5.73219986293E-02 5.78972528731E-02 5.84782629064E-02 5.90650857964E-02 5.96577791603E-02 6.02564011699E-02 6.08610105565E-02 6.14716666157E-02 6.20884292123E-02 6.27113587854E-02 6.33405163528E-02 6.39759635168E-02 6.46177624682E-02 6.52659759922E-02 6.59206674728E-02 6.65819008982E-02 6.72497408658E-02 6.79242525871E-02 6.86055018930E-02 6.92935552391E-02 6.99884797103E-02 7.06903430265E-02 7.13992135475E-02 7.21151602786E-02 7.28382528751E-02 7.35685616480E-02 7.43061575695E-02 7.50511122776E-02 7.58034980817E-02 7.65633879681E-02 7.73308556050E-02 7.81059753475E-02 7.88888222438E-02 7.96794720394E-02 8.04780011832E-02 8.12844868326E-02 8.20990068587E-02 8.29216398515E-02 8.37524651256E-02 8.45915627250E-02 8.54390134288E-02 8.62948987562E-02 8.71593009721E-02 8.80323030918E-02 8.89139888870E-02 8.98044428902E-02 9.07037504005E-02 9.16119974887E-02 9.25292710023E-02 9.34556585704E-02 9.43912486096E-02 9.53361303281E-02 9.62903937316E-02 9.72541296277E-02 9.82274296311E-02 9.92103861686E-02 1.00203092484E-01 1.01205642642E-01 1.02218131534E-01 1.03240654884E-01 1.04273309250E-01 1.05316192032E-01 1.06369401473E-01 1.07433036667E-01 1.08507197560E-01 1.09591984959E-01 1.10687500529E-01 1.11793846806E-01 1.12911127193E-01 1.14039445968E-01 1.15178908288E-01 1.16329620190E-01 1.17491688599E-01 1.18665221326E-01 1.19850327075E-01 1.21047115447E-01 1.22255696939E-01 1.23476182950E-01 1.24708685785E-01 1.25953318652E-01 1.27210195672E-01 1.28479431873E-01 1.29761143201E-01 1.31055446513E-01 1.32362459586E-01 1.33682301114E-01 1.35015090711E-01 1.36360948911E-01 1.37719997171E-01 1.39092357867E-01 1.40478154302E-01 1.41877510696E-01 1.43290552196E-01 1.44717404867E-01 1.46158195696E-01 1.47613052590E-01 1.49082104374E-01 1.50565480789E-01 1.52063312489E-01 1.53575731044E-01 1.55102868927E-01 1.56644859521E-01 1.58201837110E-01 1.59773936876E-01 1.61361294892E-01 1.62964048124E-01 1.64582334418E-01 1.66216292498E-01 1.67866061959E-01 1.69531783260E-01 1.71213597717E-01 1.72911647496E-01 1.74626075600E-01 1.76357025866E-01 1.78104642951E-01 1.79869072325E-01 1.81650460255E-01 1.83448953799E-01 1.85264700792E-01 1.87097849828E-01 1.88948550256E-01 1.90816952155E-01 1.92703206326E-01 1.94607464272E-01 1.96529878184E-01 1.98470600920E-01 2.00429785988E-01 2.02407587526E-01 2.04404160282E-01 2.06419659591E-01 2.08454241353E-01 2.10508062009E-01 2.12581278517E-01 2.14674048326E-01 2.16786529349E-01 2.18918879932E-01 2.21071258829E-01 2.23243825169E-01 2.25436738421E-01 2.27650158368E-01 2.29884245065E-01 2.32139158806E-01 2.34415060086E-01 2.36712109561E-01 2.39030468010E-01 2.41370296288E-01 2.43731755285E-01 2.46115005882E-01 2.48520208897E-01 2.50947525045E-01 2.53397114876E-01 2.55869138733E-01 2.58363756687E-01 2.60881128488E-01 2.63421413500E-01 2.65984770643E-01 2.68571358327E-01 2.71181334389E-01 2.73814856022E-01 2.76472079707E-01 2.79153161139E-01 2.81858255149E-01 2.84587515630E-01 2.87341095453E-01 2.90119146385E-01 2.92921819002E-01 2.95749262599E-01 2.98601625098E-01 3.01479052955E-01 3.04381691056E-01 3.07309682620E-01 3.10263169094E-01 3.13242290039E-01 3.16247183024E-01 3.19277983508E-01 3.22334824721E-01 3.25417837539E-01 3.28527150359E-01 3.31662888970E-01 3.34825176413E-01 3.38014132846E-01 3.41229875399E-01 3.44472518026E-01 3.47742171355E-01 3.51038942526E-01 3.54362935035E-01 3.57714248565E-01 3.61092978814E-01 3.64499217321E-01 3.67933051283E-01 3.71394563366E-01 3.74883831519E-01 3.78400928771E-01 3.81945923028E-01 3.85518876867E-01 3.89119847321E-01 3.92748885652E-01 3.96406037133E-01 4.00091340809E-01 4.03804829257E-01 4.07546528344E-01 4.11316456970E-01 4.15114626812E-01 4.18941042056E-01 4.22795699120E-01 4.26678586383E-01 4.30589683886E-01 4.34528963046E-01 4.38496386347E-01 4.42491907034E-01 4.46515468791E-01 4.50567005419E-01 4.54646440501E-01 4.58753687056E-01 4.62888647197E-01 4.67051211762E-01 4.71241259957E-01 4.75458658974E-01 4.79703263608E-01 4.83974915866E-01 4.88273444564E-01 4.92598664918E-01 4.96950378119E-01 5.01328370911E-01 5.05732415151E-01 5.10162267360E-01 5.14617668269E-01 5.19098342353E-01 5.23603997357E-01 5.28134323811E-01 5.32688994536E-01 5.37267664146E-01 5.41869968530E-01 5.46495524335E-01 5.51143928436E-01 5.55814757395E-01 5.60507566912E-01 5.65221891270E-01 5.69957242771E-01 5.74713111154E-01 5.79488963019E-01 5.84284241235E-01 5.89098364334E-01 5.93930725913E-01 5.98780694011E-01 6.03647610493E-01 6.08530790416E-01 6.13429521396E-01 6.18343062968E-01 6.23270645931E-01 6.28211471704E-01 6.33164711663E-01 6.38129506478E-01 6.43104965453E-01 6.48090165850E-01 6.53084152223E-01 6.58085935744E-01 6.63094493529E-01 6.68108767963E-01 6.73127666031E-01 6.78150058645E-01 6.83174779976E-01 6.88200626789E-01 6.93226357788E-01 6.98250692959E-01 7.03272312929E-01 7.08289858328E-01 7.13301929161E-01 7.18307084202E-01 7.23303840386E-01 7.28290672228E-01 7.33266011256E-01 7.38228245460E-01 7.43175718767E-01 7.48106730532E-01 7.53019535062E-01 7.57912341162E-01 7.62783311709E-01 7.67630563270E-01 7.72452165736E-01 7.77246142011E-01 7.82010467732E-01 7.86743071035E-01 7.91441832364E-01 7.96104584337E-01 8.00729111656E-01 8.05313151080E-01 8.09854391455E-01 8.14350473806E-01 8.18798991500E-01 8.23197490475E-01 8.27543469553E-01 8.31834380818E-01 8.36067630095E-01 8.40240577505E-01 8.44350538112E-01 8.48394782677E-01 8.52370538506E-01 8.56274990405E-01 8.60105281751E-01 8.63858515676E-01 8.67531756372E-01 8.71122030528E-01 8.74626328893E-01 8.78041607983E-01 8.81364791923E-01 8.84592774441E-01 8.87722421020E-01 8.90750571196E-01 8.93674041035E-01 8.96489625768E-01 8.99194102601E-01 9.01784233713E-01 9.04256769424E-01 9.06608451567E-01 9.08836017036E-01 9.10936201550E-01 9.12905743601E-01 9.14741388619E-01 9.16439893337E-01 9.17998030374E-01 9.19412593025E-01 9.20680400270E-01 9.21798301997E-01 9.22763184448E-01 9.23571975870E-01 9.24221652395E-01 9.24709244130E-01 9.25031841452E-01 9.25186601523E-01 9.25170754999E-01 9.24981612944E-01 9.24616573928E-01 9.24073131309E-01 9.23348880693E-01 9.22441527543E-01 9.21348894948E-01 9.20068931514E-01 9.18599719374E-01 9.16939482299E-01 9.15086593876E-01 9.13039585743E-01 9.10797155854E-01 9.08358176732E-01 9.05721703700E-01 9.02886983038E-01 8.99853460046E-01 8.96620786955E-01 8.93188830663E-01 8.89557680234E-01 8.85727654125E-01 8.81699307074E-01 8.77473436607E-01 8.73051089099E-01 8.68433565318E-01 8.63622425401E-01 8.58619493180E-01 8.53426859785E-01 8.48046886455E-01 8.42482206459E-01 8.36735726065E-01 8.30810624439E-01 8.24710352415E-01 8.18438630009E-01 8.11999442608E-01 8.05397035707E-01 7.98635908109E-01 7.91720803479E-01 7.84656700137E-01 7.77448798986E-01 7.70102509482E-01 7.62623433504E-01 7.55017347050E-01 7.47290179635E-01 7.39447991293E-01 7.31496947074E-01 7.23443288961E-01 7.15293305090E-01 7.07053296221E-01 6.98729539357E-01 6.90328248466E-01 6.81855532251E-01 6.73317348923E-01 6.64719457958E-01 6.56067368839E-01 6.47366286786E-01 6.38621055513E-01 6.29836097086E-01 6.21015348948E-01 6.12162198243E-01 6.03279413593E-01 5.94369074493E-01 5.85432498566E-01 5.76470967813E-01 5.67488364101E-01 5.58489263148E-01 5.49478203747E-01 5.40459684372E-01 5.31438159828E-01 5.22418037948E-01 5.13403676351E-01 5.04399379248E-01 4.95409394292E-01 4.86434953054E-01 4.77483103657E-01 4.68557905070E-01 4.59663347707E-01 4.50803350618E-01 4.41981758763E-01 4.33202340347E-01 4.24468784247E-01 4.15784697518E-01 4.07153602989E-01 3.98578936949E-01 3.90064046935E-01 3.81612189610E-01 3.73226528750E-01 3.64910133343E-01 3.56665975788E-01 3.48496930220E-01 3.40405770945E-01 3.32395171007E-01 3.24467700873E-01 3.16625827252E-01 3.08871912046E-01 3.01208211434E-01 2.93636875099E-01 2.86159945592E-01 2.78779357837E-01 2.71496938783E-01 2.64314407198E-01 2.57233373607E-01 2.50255340384E-01 2.43381701972E-01 2.36613745264E-01 2.29952650116E-01 2.23399490004E-01 2.16955232818E-01 2.10620741791E-01 2.04396776561E-01 1.98283994359E-01 1.92282951321E-01 1.86394103918E-01 1.80617810505E-01 1.74954332970E-01 1.69403838492E-01 1.63966401397E-01 1.58642005096E-01 1.53430544122E-01 1.48331826230E-01 1.43345574581E-01 1.38471429987E-01 1.33708953211E-01 1.29057627326E-01 1.24516860116E-01 1.20085986521E-01 1.15764271108E-01 1.11550910579E-01 1.07445036295E-01 1.03445716819E-01 9.95519604690E-02 9.57627178778E-02 9.20768845548E-02 8.84933034441E-02 8.50107674757E-02 8.16280221063E-02 7.83437678448E-02 7.51566627610E-02 7.20653249736E-02 6.90683351149E-02 6.61642387702E-02 6.33515488901E-02 6.06287481738E-02 5.79942914207E-02 5.54466078518E-02 5.29841033970E-02 5.06051629488E-02 4.83081525818E-02 4.60914217364E-02 4.39533053673E-02 4.18921260558E-02 3.99061960849E-02 3.79938194785E-02 3.61532940015E-02 3.43829131240E-02 3.26809679453E-02 3.10457490799E-02 2.94755485032E-02 2.79686613572E-02 2.65233877144E-02 2.51380342993E-02 2.38109161662E-02 2.25403583329E-02 2.13246973670E-02 2.01622829258E-02 1.90514792467E-02 1.79906665864E-02 1.69782426089E-02 1.60126237186E-02 1.50922463385E-02 1.42155681310E-02 1.33810691598E-02 1.25872529922E-02 1.18326477389E-02 1.11158070315E-02 1.04353109351E-02 9.78976679684E-03 9.17781002720E-03 8.59810481502E-03 8.04934477519E-03 7.53025352863E-03 7.03958521451E-03 6.57612493483E-03 6.13868913156E-03 5.72612589707E-03 5.33731521834E-03 4.97116915609E-03 4.62663195983E-03 4.30268012038E-03 3.99832236111E-03 3.71259956994E-03 3.44458467371E-03 3.19338245722E-03 2.95812932885E-03 2.73799303538E-03 2.53217232821E-03 2.33989658362E-03 2.16042537971E-03 1.99304803264E-03 1.83708309506E-03 1.69187781931E-03 1.55680758844E-03 1.43127531771E-03 1.31471082956E-03 1.20657020465E-03 1.10633511206E-03 1.01351212108E-03 9.27631997632E-04 8.48248987623E-04 7.74940090134E-04 7.07304322709E-04 6.44961981272E-04 5.87553896970E-04 5.34740692148E-04 4.86202037598E-04 4.41635913079E-04 4.00757872992E-04 3.63300319024E-04 3.29011781382E-04 2.97656210196E-04 2.69012278487E-04 2.42872698022E-04 2.19043549225E-04 1.97343626217E-04 1.77603797931E-04 1.59666386132E-04 1.43384561070E-04 1.28621755377E-04 1.15251096709E-04 1.03154859560E-04 9.22239365322E-05 8.23573293119E-05 7.34616594533E-05 6.54506990404E-05 5.82449211877E-05 5.17710702824E-05 4.59617517988E-05 4.07550414550E-05 3.60941134264E-05 3.19268872756E-05 2.82056932133E-05 2.48869552676E-05 2.19308918975E-05 1.93012335553E-05 1.69649566781E-05 1.48920335636E-05 1.30551975689E-05 1.14297230555E-05 9.99321949435E-06 8.72543913617E-06 7.60809765179E-06 6.62470714394E-06 5.76042093698E-06 5.00188955520E-06 4.33712730892E-06 3.75538891755E-06 3.24705561106E-06 2.80353016569E-06 2.41714034520E-06 2.08105023668E-06 1.78917898886E-06 1.53610359751E-06 1.31680922148E-06 1.12706178730E-06 9.63137612552E-07 8.21746537718E-07 6.99986147099E-07 5.95300245554E-07 5.05441262075E-07 4.28436269315E-07 3.62556326301E-07 3.06288869169E-07 2.58312892034E-07 2.17476676815E-07 1.82777847049E-07 1.53345536306E-07 1.28424476844E-07 1.07360828451E-07 8.95895811036E-08 7.46233780922E-08 6.20426185423E-08 5.14867099192E-08 4.26463520406E-08 3.52567443976E-08 2.90916182025E-08 2.39580035524E-08 1.96916504445E-08 1.61530301190E-08 1.32238503689E-08 1.08040250594E-08 8.80904417451E-09 7.16769628227E-09 5.82010040579E-09 4.71600893810E-09 3.81334746920E-09 3.07696123261E-09 2.47754135354E-09 1.99070721754E-09 1.59622410420E-09 1.27733776972E-09 1.02020994017E-09 8.13440717338E-10 6.47665725349E-10 5.15217460175E-10 4.09841769945E-10 3.25250566360E-10 2.57505105778E-10 2.03380451645E-10 1.60242490134E-10 1.25944935272E-10 9.87432910027E-11 7.72231603501E-11 6.02406618488E-11 4.68730361629E-11 3.63778065970E-11 2.81591007359E-11 2.17399510469E-11 1.67395738481E-11 1.28547821275E-11 9.84482146487E-12 7.51903260082E-12 5.72684156110E-12 4.34966092897E-12 3.29435586501E-12 2.48798756168E-12 1.87359653949E-12 1.40682989633E-12 1.05325149445E-12 7.86203137969E-13 5.85108946332E-13 4.34135133803E-13 3.21133920083E-13 2.36813887881E-13 1.74090250484E-13 1.27577605646E-13 9.31951778750E-14 6.78605817128E-14 4.92530196873E-14 3.56307658895E-14 2.56909513606E-14 1.84622032603E-14 1.32227142952E-14 9.43792956343E-15 6.71331490458E-15 4.75867960605E-15 3.36132037449E-15 2.36587628986E-15 1.65927117356E-15 1.15949877020E-15 8.07300129520E-16 5.60009786904E-16 3.87022287476E-16 2.66464792467E-16 1.82764047476E-16 1.24874045493E-16 8.49899000015E-17 5.76181419952E-17 3.89072806216E-17 2.61676626114E-17 1.75284683386E-17 1.16936574761E-17 7.76902171308E-18 5.14012751228E-18 3.38652966832E-18 2.22172842654E-18 1.45132150463E-18 9.43961214710E-19 6.11284851933E-19 3.94105950357E-19 2.52954811639E-19 1.61627039434E-19 1.02803178150E-19 6.50879579264E-20 4.10181685598E-20 2.57284207336E-20 1.60616723956E-20 9.97903369701E-21 6.17000361479E-21 3.79629937875E-21 2.32430055288E-21 1.41598740143E-21 8.58301802513E-22 5.17621410832E-22 3.10565945186E-22 1.85371267959E-22 1.10066554037E-22 6.50084518378E-23 3.81911464794E-23 2.23157079346E-23 1.29685132386E-23 7.49510065026E-24 4.30773004086E-24 2.46194841109E-24 1.39908584637E-24 7.90532925137E-25 4.44099963174E-25 2.48028407733E-25 1.37707156811E-25 7.60011606369E-26 4.16933251866E-26 2.27336486773E-26 1.23197388263E-26 6.63493663257E-27 3.55097721446E-27 1.88845853369E-27 9.97901879790E-28 5.23915357411E-28 2.73274506025E-28 1.41603283510E-28 7.28878226693E-29 3.72661920711E-29 1.89244861236E-29 9.54448638919E-30 4.78046866619E-30 2.37764815905E-30 1.17423048655E-30 5.75780441180E-31 2.80302577188E-31 1.35466658823E-31 6.49891859484E-32 3.09471747443E-32 1.46264762534E-32 6.86063699949E-33 3.19346458654E-33 1.47502463168E-33 6.75992974188E-34 3.07366640093E-34 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2P 1 4.00 Wavefunction 1.84474960423E-07 1.88201601482E-07 1.92003525669E-07 1.95882253805E-07 1.99839337432E-07 2.03876359435E-07 2.07994934676E-07 2.12196710638E-07 2.16483368088E-07 2.20856621743E-07 2.25318220964E-07 2.29869950447E-07 2.34513630944E-07 2.39251119988E-07 2.44084312637E-07 2.49015142230E-07 2.54045581164E-07 2.59177641680E-07 2.64413376668E-07 2.69754880492E-07 2.75204289822E-07 2.80763784493E-07 2.86435588374E-07 2.92221970262E-07 2.98125244785E-07 3.04147773328E-07 3.10291964981E-07 3.16560277501E-07 3.22955218293E-07 3.29479345418E-07 3.36135268611E-07 3.42925650326E-07 3.49853206805E-07 3.56920709159E-07 3.64130984481E-07 3.71486916974E-07 3.78991449105E-07 3.86647582785E-07 3.94458380566E-07 4.02426966867E-07 4.10556529225E-07 4.18850319570E-07 4.27311655525E-07 4.35943921732E-07 4.44750571208E-07 4.53735126727E-07 4.62901182225E-07 4.72252404242E-07 4.81792533386E-07 4.91525385832E-07 5.01454854843E-07 5.11584912334E-07 5.21919610458E-07 5.32463083225E-07 5.43219548158E-07 5.54193307980E-07 5.65388752333E-07 5.76810359539E-07 5.88462698383E-07 6.00350429949E-07 6.12478309480E-07 6.24851188281E-07 6.37474015659E-07 6.50351840904E-07 6.63489815308E-07 6.76893194226E-07 6.90567339177E-07 7.04517719992E-07 7.18749916996E-07 7.33269623247E-07 7.48082646808E-07 7.63194913073E-07 7.78612467137E-07 7.94341476213E-07 8.10388232099E-07 8.26759153698E-07 8.43460789580E-07 8.60499820605E-07 8.77883062597E-07 8.95617469066E-07 9.13710133992E-07 9.32168294665E-07 9.50999334573E-07 9.70210786363E-07 9.89810334850E-07 1.00980582009E-06 1.03020524053E-06 1.05101675617E-06 1.07224869188E-06 1.09390954069E-06 1.11600796720E-06 1.13855281104E-06 1.16155309042E-06 1.18501800574E-06 1.20895694323E-06 1.23337947876E-06 1.25829538163E-06 1.28371461850E-06 1.30964735736E-06 1.33610397162E-06 1.36309504424E-06 1.39063137195E-06 1.41872396962E-06 1.44738407461E-06 1.47662315130E-06 1.50645289565E-06 1.53688523991E-06 1.56793235738E-06 1.59960666724E-06 1.63192083960E-06 1.66488780048E-06 1.69852073705E-06 1.73283310287E-06 1.76783862327E-06 1.80355130086E-06 1.83998542109E-06 1.87715555804E-06 1.91507658017E-06 1.95376365631E-06 1.99323226171E-06 2.03349818427E-06 2.07457753077E-06 2.11648673342E-06 2.15924255635E-06 2.20286210235E-06 2.24736281971E-06 2.29276250920E-06 2.33907933116E-06 2.38633181283E-06 2.43453885569E-06 2.48371974308E-06 2.53389414784E-06 2.58508214028E-06 2.63730419611E-06 2.69058120469E-06 2.74493447738E-06 2.80038575602E-06 2.85695722169E-06 2.91467150355E-06 2.97355168787E-06 3.03362132732E-06 3.09490445033E-06 3.15742557076E-06 3.22120969765E-06 3.28628234527E-06 3.35266954330E-06 3.42039784723E-06 3.48949434903E-06 3.55998668794E-06 3.63190306154E-06 3.70527223703E-06 3.78012356274E-06 3.85648697988E-06 3.93439303449E-06 4.01387288966E-06 4.09495833804E-06 4.17768181449E-06 4.26207640910E-06 4.34817588043E-06 4.43601466897E-06 4.52562791094E-06 4.61705145239E-06 4.71032186343E-06 4.80547645299E-06 4.90255328361E-06 5.00159118679E-06 5.10262977841E-06 5.20570947467E-06 5.31087150820E-06 5.41815794456E-06 5.52761169907E-06 5.63927655400E-06 5.75319717603E-06 5.86941913419E-06 5.98798891800E-06 6.10895395613E-06 6.23236263535E-06 6.35826431988E-06 6.48670937115E-06 6.61774916791E-06 6.75143612682E-06 6.88782372340E-06 7.02696651340E-06 7.16892015467E-06 7.31374142936E-06 7.46148826669E-06 7.61221976607E-06 7.76599622078E-06 7.92287914206E-06 8.08293128372E-06 8.24621666725E-06 8.41280060741E-06 8.58274973836E-06 8.75613204033E-06 8.93301686677E-06 9.11347497215E-06 9.29757854018E-06 9.48540121277E-06 9.67701811940E-06 9.87250590724E-06 1.00719427718E-05 1.02754084880E-05 1.04829844426E-05 1.06947536661E-05 1.09108008664E-05 1.11312124626E-05 1.13560766192E-05 1.15854832821E-05 1.18195242139E-05 1.20582930308E-05 1.23018852401E-05 1.25503982786E-05 1.28039315511E-05 1.30625864706E-05 1.33264664985E-05 1.35956771862E-05 1.38703262173E-05 1.41505234508E-05 1.44363809646E-05 1.47280131007E-05 1.50255365108E-05 1.53290702031E-05 1.56387355897E-05 1.59546565352E-05 1.62769594064E-05 1.66057731226E-05 1.69412292073E-05 1.72834618407E-05 1.76326079137E-05 1.79888070822E-05 1.83522018230E-05 1.87229374911E-05 1.91011623778E-05 1.94870277695E-05 1.98806880089E-05 2.02823005561E-05 2.06920260521E-05 2.11100283826E-05 2.15364747438E-05 2.19715357094E-05 2.24153852983E-05 2.28682010447E-05 2.33301640689E-05 2.38014591498E-05 2.42822747985E-05 2.47728033341E-05 2.52732409605E-05 2.57837878447E-05 2.63046481968E-05 2.68360303520E-05 2.73781468537E-05 2.79312145383E-05 2.84954546224E-05 2.90710927908E-05 2.96583592870E-05 3.02574890050E-05 3.08687215837E-05 3.14923015022E-05 3.21284781780E-05 3.27775060665E-05 3.34396447626E-05 3.41151591048E-05 3.48043192812E-05 3.55074009370E-05 3.62246852852E-05 3.69564592188E-05 3.77030154257E-05 3.84646525055E-05 3.92416750892E-05 4.00343939605E-05 4.08431261806E-05 4.16681952148E-05 4.25099310617E-05 4.33686703850E-05 4.42447566487E-05 4.51385402538E-05 4.60503786787E-05 4.69806366219E-05 4.79296861482E-05 4.88979068371E-05 4.98856859346E-05 5.08934185082E-05 5.19215076046E-05 5.29703644109E-05 5.40404084193E-05 5.51320675941E-05 5.62457785436E-05 5.73819866941E-05 5.85411464680E-05 5.97237214656E-05 6.09301846505E-05 6.21610185385E-05 6.34167153904E-05 6.46977774090E-05 6.60047169396E-05 6.73380566750E-05 6.86983298643E-05 7.00860805262E-05 7.15018636661E-05 7.29462454982E-05 7.44198036720E-05 7.59231275025E-05 7.74568182064E-05 7.90214891422E-05 8.06177660551E-05 8.22462873272E-05 8.39077042328E-05 8.56026811986E-05 8.73318960688E-05 8.90960403767E-05 9.08958196204E-05 9.27319535452E-05 9.46051764308E-05 9.65162373849E-05 9.84659006427E-05 1.00454945872E-04 1.02484168484E-04 1.04554379954E-04 1.06666408141E-04 1.08821097622E-04 1.11019310029E-04 1.13261924393E-04 1.15549837492E-04 1.17883964214E-04 1.20265237922E-04 1.22694610823E-04 1.25173054350E-04 1.27701559554E-04 1.30281137494E-04 1.32912819645E-04 1.35597658306E-04 1.38336727026E-04 1.41131121027E-04 1.43981957644E-04 1.46890376773E-04 1.49857541321E-04 1.52884637677E-04 1.55972876181E-04 1.59123491608E-04 1.62337743663E-04 1.65616917481E-04 1.68962324143E-04 1.72375301199E-04 1.75857213199E-04 1.79409452242E-04 1.83033438529E-04 1.86730620929E-04 1.90502477561E-04 1.94350516382E-04 1.98276275786E-04 2.02281325224E-04 2.06367265825E-04 2.10535731039E-04 2.14788387284E-04 2.19126934616E-04 2.23553107404E-04 2.28068675025E-04 2.32675442567E-04 2.37375251548E-04 2.42169980657E-04 2.47061546497E-04 2.52051904351E-04 2.57143048965E-04 2.62337015339E-04 2.67635879543E-04 2.73041759540E-04 2.78556816037E-04 2.84183253340E-04 2.89923320237E-04 2.95779310893E-04 3.01753565764E-04 3.07848472534E-04 3.14066467060E-04 3.20410034350E-04 3.26881709546E-04 3.33484078943E-04 3.40219781010E-04 3.47091507450E-04 3.54102004268E-04 3.61254072863E-04 3.68550571150E-04 3.75994414693E-04 3.83588577869E-04 3.91336095052E-04 3.99240061820E-04 4.07303636191E-04 4.15530039876E-04 4.23922559565E-04 4.32484548234E-04 4.41219426479E-04 4.50130683880E-04 4.59221880387E-04 4.68496647735E-04 4.77958690896E-04 4.87611789544E-04 4.97459799565E-04 5.07506654589E-04 5.17756367553E-04 5.28213032296E-04 5.38880825190E-04 5.49764006800E-04 5.60866923573E-04 5.72194009571E-04 5.83749788230E-04 5.95538874157E-04 6.07565974966E-04 6.19835893146E-04 6.32353527969E-04 6.45123877435E-04 6.58152040258E-04 6.71443217888E-04 6.85002716578E-04 6.98835949488E-04 7.12948438835E-04 7.27345818082E-04 7.42033834174E-04 7.57018349817E-04 7.72305345803E-04 7.87900923380E-04 8.03811306672E-04 8.20042845147E-04 8.36602016131E-04 8.53495427373E-04 8.70729819666E-04 8.88312069515E-04 9.06249191857E-04 9.24548342845E-04 9.43216822670E-04 9.62262078461E-04 9.81691707222E-04 1.00151345884E-03 1.02173523915E-03 1.04236511307E-03 1.06341130777E-03 1.08488221592E-03 1.10678639904E-03 1.12913259084E-03 1.15192970071E-03 1.17518681719E-03 1.19891321160E-03 1.22311834166E-03 1.24781185525E-03 1.27300359421E-03 1.29870359819E-03 1.32492210865E-03 1.35166957287E-03 1.37895664805E-03 1.40679420555E-03 1.43519333513E-03 1.46416534931E-03 1.49372178786E-03 1.52387442230E-03 1.55463526054E-03 1.58601655159E-03 1.61803079038E-03 1.65069072266E-03 1.68400935002E-03 1.71799993495E-03 1.75267600609E-03 1.78805136348E-03 1.82414008403E-03 1.86095652697E-03 1.89851533952E-03 1.93683146258E-03 1.97592013661E-03 2.01579690758E-03 2.05647763303E-03 2.09797848827E-03 2.14031597270E-03 2.18350691624E-03 2.22756848591E-03 2.27251819251E-03 2.31837389743E-03 2.36515381962E-03 2.41287654268E-03 2.46156102209E-03 2.51122659257E-03 2.56189297559E-03 2.61358028703E-03 2.66630904500E-03 2.72010017776E-03 2.77497503186E-03 2.83095538043E-03 2.88806343153E-03 2.94632183681E-03 3.00575370023E-03 3.06638258701E-03 3.12823253267E-03 3.19132805238E-03 3.25569415031E-03 3.32135632936E-03 3.38834060089E-03 3.45667349475E-03 3.52638206949E-03 3.59749392270E-03 3.67003720165E-03 3.74404061400E-03 3.81953343888E-03 3.89654553799E-03 3.97510736708E-03 4.05524998756E-03 4.13700507832E-03 4.22040494781E-03 4.30548254638E-03 4.39227147870E-03 4.48080601666E-03 4.57112111224E-03 4.66325241085E-03 4.75723626477E-03 4.85310974692E-03 4.95091066484E-03 5.05067757496E-03 5.15244979712E-03 5.25626742937E-03 5.36217136304E-03 5.47020329805E-03 5.58040575857E-03 5.69282210895E-03 5.80749656988E-03 5.92447423489E-03 6.04380108721E-03 6.16552401683E-03 6.28969083792E-03 6.41635030657E-03 6.54555213887E-03 6.67734702925E-03 6.81178666921E-03 6.94892376637E-03 7.08881206384E-03 7.23150635996E-03 7.37706252839E-03 7.52553753853E-03 7.67698947633E-03 7.83147756544E-03 7.98906218877E-03 8.14980491038E-03 8.31376849780E-03 8.48101694466E-03 8.65161549383E-03 8.82563066083E-03 9.00313025774E-03 9.18418341750E-03 9.36886061853E-03 9.55723370993E-03 9.74937593697E-03 9.94536196706E-03 1.01452679162E-02 1.03491713756E-02 1.05571514395E-02 1.07692887323E-02 1.09856654370E-02 1.12063653238E-02 1.14314737796E-02 1.16610778368E-02 1.18952662042E-02 1.21341292969E-02 1.23777592677E-02 1.26262500384E-02 1.28796973318E-02 1.31381987045E-02 1.34018535796E-02 1.36707632801E-02 1.39450310632E-02 1.42247621548E-02 1.45100637844E-02 1.48010452205E-02 1.50978178071E-02 1.54004950000E-02 1.57091924039E-02 1.60240278104E-02 1.63451212357E-02 1.66725949596E-02 1.70065735647E-02 1.73471839763E-02 1.76945555025E-02 1.80488198751E-02 1.84101112912E-02 1.87785664549E-02 1.91543246196E-02 1.95375276316E-02 1.99283199730E-02 2.03268488059E-02 2.07332640172E-02 2.11477182633E-02 2.15703670162E-02 2.20013686090E-02 2.24408842832E-02 2.28890782350E-02 2.33461176637E-02 2.38121728194E-02 2.42874170514E-02 2.47720268576E-02 2.52661819338E-02 2.57700652234E-02 2.62838629681E-02 2.68077647586E-02 2.73419635855E-02 2.78866558911E-02 2.84420416212E-02 2.90083242774E-02 2.95857109696E-02 3.01744124691E-02 3.07746432614E-02 3.13866216001E-02 3.20105695602E-02 3.26467130921E-02 3.32952820755E-02 3.39565103741E-02 3.46306358892E-02 3.53179006145E-02 3.60185506905E-02 3.67328364587E-02 3.74610125164E-02 3.82033377703E-02 3.89600754913E-02 3.97314933682E-02 4.05178635615E-02 4.13194627568E-02 4.21365722177E-02 4.29694778392E-02 4.38184701989E-02 4.46838446096E-02 4.55659011700E-02 4.64649448150E-02 4.73812853657E-02 4.83152375779E-02 4.92671211901E-02 5.02372609704E-02 5.12259867625E-02 5.22336335298E-02 5.32605413990E-02 5.43070557021E-02 5.53735270165E-02 5.64603112038E-02 5.75677694466E-02 5.86962682841E-02 5.98461796445E-02 6.10178808763E-02 6.22117547768E-02 6.34281896184E-02 6.46675791719E-02 6.59303227275E-02 6.72168251125E-02 6.85274967062E-02 6.98627534510E-02 7.12230168608E-02 7.26087140251E-02 7.40202776091E-02 7.54581458501E-02 7.69227625497E-02 7.84145770606E-02 7.99340442697E-02 8.14816245750E-02 8.30577838583E-02 8.46629934515E-02 8.62977300971E-02 8.79624759033E-02 8.96577182915E-02 9.13839499380E-02 9.31416687081E-02 9.49313775831E-02 9.67535845788E-02 9.86088026572E-02 1.00497549628E-01 1.02420348045E-01 1.04377725084E-01 1.06370212425E-01 1.08398346112E-01 1.10462666410E-01 1.12563717644E-01 1.14702048036E-01 1.16878209519E-01 1.19092757550E-01 1.21346250902E-01 1.23639251442E-01 1.25972323906E-01 1.28346035643E-01 1.30760956360E-01 1.33217657840E-01 1.35716713647E-01 1.38258698822E-01 1.40844189545E-01 1.43473762798E-01 1.46147995994E-01 1.48867466595E-01 1.51632751709E-01 1.54444427661E-01 1.57303069552E-01 1.60209250787E-01 1.63163542585E-01 1.66166513463E-01 1.69218728700E-01 1.72320749768E-01 1.75473133746E-01 1.78676432701E-01 1.81931193044E-01 1.85237954860E-01 1.88597251202E-01 1.92009607364E-01 1.95475540116E-01 1.98995556913E-01 2.02570155066E-01 2.06199820887E-01 2.09885028792E-01 2.13626240376E-01 2.17423903450E-01 2.21278451039E-01 2.25190300348E-01 2.29159851685E-01 2.33187487350E-01 2.37273570481E-01 2.41418443859E-01 2.45622428680E-01 2.49885823273E-01 2.54208901790E-01 2.58591912839E-01 2.63035078087E-01 2.67538590811E-01 2.72102614408E-01 2.76727280858E-01 2.81412689147E-01 2.86158903640E-01 2.90965952415E-01 2.95833825544E-01 3.00762473333E-01 3.05751804523E-01 3.10801684431E-01 3.15911933065E-01 3.21082323182E-01 3.26312578305E-01 3.31602370705E-01 3.36951319332E-01 3.42358987711E-01 3.47824881797E-01 3.53348447798E-01 3.58929069949E-01 3.64566068268E-01 3.70258696267E-01 3.76006138644E-01 3.81807508939E-01 3.87661847173E-01 3.93568117463E-01 3.99525205619E-01 4.05531916731E-01 4.11586972746E-01 4.17689010035E-01 4.23836576967E-01 4.30028131486E-01 4.36262038697E-01 4.42536568473E-01 4.48849893081E-01 4.55200084843E-01 4.61585113831E-01 4.68002845612E-01 4.74451039044E-01 4.80927344138E-01 4.87429299989E-01 4.93954332793E-01 5.00499753957E-01 5.07062758312E-01 5.13640422442E-01 5.20229703145E-01 5.26827436030E-01 5.33430334271E-01 5.40034987534E-01 5.46637861082E-01 5.53235295083E-01 5.59823504129E-01 5.66398576995E-01 5.72956476634E-01 5.79493040454E-01 5.86003980864E-01 5.92484886140E-01 5.98931221598E-01 6.05338331123E-01 6.11701439054E-01 6.18015652453E-01 6.24275963781E-01 6.30477253998E-01 6.36614296113E-01 6.42681759195E-01 6.48674212880E-01 6.54586132389E-01 6.60411904074E-01 6.66145831521E-01 6.71782142221E-01 6.77314994839E-01 6.82738487087E-01 6.88046664236E-01 6.93233528261E-01 6.98293047657E-01 7.03219167923E-01 7.08005822732E-01 7.12646945800E-01 7.17136483450E-01 7.21468407887E-01 7.25636731180E-01 7.29635519945E-01 7.33458910732E-01 7.37101126096E-01 7.40556491343E-01 7.43819451933E-01 7.46884591507E-01 7.49746650519E-01 7.52400545417E-01 7.54841388355E-01 7.57064507360E-01 7.59065466905E-01 7.60840088832E-01 7.62384473518E-01 7.63695021239E-01 7.64768453597E-01 7.65601834939E-01 7.66192593618E-01 7.66538543002E-01 7.66637902065E-01 7.66489315419E-01 7.66091872630E-01 7.65445126623E-01 7.64549111007E-01 7.63404356101E-01 7.62011903454E-01 7.60373318628E-01 7.58490701997E-01 7.56366697313E-01 7.54004497770E-01 7.51407849280E-01 7.48581050686E-01 7.45528950588E-01 7.42256940498E-01 7.38770943984E-01 7.35077401497E-01 7.31183250540E-01 7.27095900863E-01 7.22823204342E-01 7.18373419229E-01 7.13755168447E-01 7.08977391628E-01 7.04049290598E-01 6.98980268034E-01 6.93779859052E-01 6.88457655494E-01 6.83023222740E-01 6.77486008889E-01 6.71855246232E-01 6.66139844956E-01 6.60348279119E-01 6.54488464983E-01 6.48567631884E-01 6.42592185890E-01 6.36567566628E-01 6.30498097732E-01 6.24386831495E-01 6.18235388451E-01 6.12043792725E-01 6.05811184693E-01 5.99538973642E-01 5.93229293557E-01 5.86884283232E-01 5.80506085169E-01 5.74096844476E-01 5.67658707753E-01 5.61193821976E-01 5.54704333368E-01 5.48192386261E-01 5.41660121956E-01 5.35109677560E-01 5.28543184826E-01 5.21962768974E-01 5.15370547502E-01 5.08768628994E-01 5.02159111907E-01 4.95544083361E-01 4.88925617910E-01 4.82305776313E-01 4.75686604298E-01 4.69070131322E-01 4.62458369329E-01 4.55853311508E-01 4.49256931057E-01 4.42671179951E-01 4.36097987721E-01 4.29539260241E-01 4.22996878539E-01 4.16472697620E-01 4.09968545319E-01 4.03486221173E-01 3.97027495338E-01 3.90594107526E-01 3.84187765992E-01 3.77810146562E-01 3.71462891705E-01 3.65147609659E-01 3.58865873611E-01 3.52619220933E-01 3.46409152478E-01 3.40237131939E-01 3.34104585278E-01 3.28012900210E-01 3.21963425772E-01 3.15957471945E-01 3.09996309356E-01 3.04081169049E-01 2.98213242324E-01 2.92393680646E-01 2.86623595619E-01 2.80904059033E-01 2.75236102969E-01 2.69620719971E-01 2.64058863270E-01 2.58551447072E-01 2.53099346894E-01 2.47703399947E-01 2.42364405565E-01 2.37083125675E-01 2.31860285303E-01 2.26696573104E-01 2.21592641925E-01 2.16549109385E-01 2.11566558472E-01 2.06645538147E-01 2.01786563961E-01 1.96990118661E-01 1.92256652804E-01 1.87586585351E-01 1.82980304257E-01 1.78438167036E-01 1.73960501306E-01 1.69547605314E-01 1.65199748423E-01 1.60917171575E-01 1.56700087721E-01 1.52548682205E-01 1.48463113125E-01 1.44443511646E-01 1.40489982278E-01 1.36602603112E-01 1.32781426027E-01 1.29026476850E-01 1.25337755488E-01 1.21715236022E-01 1.18158866778E-01 1.14668570363E-01 1.11244243686E-01 1.07885757949E-01 1.04592958633E-01 1.01365665467E-01 9.82036723903E-02 9.51067475181E-02 9.20746331040E-02 8.91070455148E-02 8.62036752170E-02 8.33641867806E-02 8.05882189054E-02 7.78753844734E-02 7.52252706320E-02 7.26374389113E-02 7.01114253797E-02 6.76467408393E-02 6.52428710658E-02 6.28992770932E-02 6.06153955465E-02 5.83906390233E-02 5.62243965249E-02 5.41160339375E-02 5.20648945642E-02 5.00702997065E-02 4.81315492954E-02 4.62479225699E-02 4.44186788024E-02 4.26430580692E-02 4.09202820629E-02 3.92495549455E-02 3.76300642385E-02 3.60609817489E-02 3.45414645257E-02 3.30706558457E-02 3.16476862248E-02 3.02716744506E-02 2.89417286341E-02 2.76569472766E-02 2.64164203480E-02 2.52192303734E-02 2.40644535245E-02 2.29511607129E-02 2.18784186808E-02 2.08452910876E-02 1.98508395876E-02 1.88941248973E-02 1.79742078484E-02 1.70901504243E-02 1.62410167772E-02 1.54258742242E-02 1.46437942184E-02 1.38938532951E-02 1.31751339891E-02 1.24867257230E-02 1.18277256633E-02 1.11972395440E-02 1.05943824562E-02 1.00182796016E-02 9.46806701060E-03 8.94289222213E-03 8.44191492632E-03 7.96430756837E-03 7.50925591356E-03 7.07595957313E-03 6.66363249086E-03 6.27150339032E-03 5.89881618296E-03 5.54483033718E-03 5.20882120880E-03 4.89008033332E-03 4.58791568054E-03 4.30165187216E-03 4.03063036308E-03 3.77420958725E-03 3.53176506886E-03 3.30268949988E-03 3.08639278498E-03 2.88230205482E-03 2.68986164894E-03 2.50853306929E-03 2.33779490569E-03 2.17714273448E-03 2.02608899155E-03 1.88416282111E-03 1.75090990148E-03 1.62589224927E-03 1.50868800322E-03 1.39889118918E-03 1.29611146737E-03 1.19997386342E-03 1.11011848447E-03 1.02620022174E-03 9.47888440726E-04 8.74866660437E-04 8.06832222918E-04 7.43495954269E-04 6.84581818448E-04 6.29826565009E-04 5.78979371979E-04 5.31801484988E-04 4.88065853778E-04 4.47556767161E-04 4.10069487470E-04 3.75409885495E-04 3.43394076904E-04 3.13848062161E-04 2.86607298669E-04 2.61517128456E-04 2.38427103632E-04 2.17210091182E-04 1.97719049810E-04 1.79811545496E-04 1.63369979258E-04 1.48288813593E-04 1.34468876748E-04 1.21817074285E-04 1.10246106767E-04 9.96741942008E-05 9.00248074691E-05 8.12264069969E-05 7.32121888573E-05 6.59198384897E-05 5.92912921744E-05 5.32725063754E-05 4.78132350336E-05 4.28668148642E-05 3.83899586841E-05 3.43425567713E-05 3.06874862310E-05 2.73904283198E-05 2.44196936595E-05 2.17460552499E-05 1.93425891686E-05 1.71845229163E-05 1.52490905899E-05 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 3.61186480350E-07 3.68482946168E-07 3.75926810981E-07 3.83521052472E-07 3.91268708476E-07 3.99172878201E-07 4.07236723460E-07 4.15463469942E-07 4.23856408502E-07 4.32418896472E-07 4.41154359011E-07 4.50066290472E-07 4.59158255799E-07 4.68433891954E-07 4.77896909372E-07 4.87551093447E-07 4.97400306043E-07 5.07448487040E-07 5.17699655913E-07 5.28157913336E-07 5.38827442823E-07 5.49712512404E-07 5.60817476333E-07 5.72146776823E-07 5.83704945832E-07 5.95496606871E-07 6.07526476854E-07 6.19799367986E-07 6.32320189686E-07 6.45093950555E-07 6.58125760377E-07 6.71420832161E-07 6.84984484233E-07 6.98822142355E-07 7.12939341903E-07 7.27341730078E-07 7.42035068166E-07 7.57025233840E-07 7.72318223518E-07 7.87920154754E-07 8.03837268691E-07 8.20075932555E-07 8.36642642205E-07 8.53544024727E-07 8.70786841091E-07 8.88377988850E-07 9.06324504904E-07 9.24633568314E-07 9.43312503171E-07 9.62368781533E-07 9.81810026404E-07 1.00164401480E-06 1.02187868083E-06 1.04252211891E-06 1.06358258698E-06 1.08506850979E-06 1.10698848232E-06 1.12935127315E-06 1.15216582805E-06 1.17544127348E-06 1.19918692028E-06 1.22341226743E-06 1.24812700575E-06 1.27334102189E-06 1.29906440221E-06 1.32530743685E-06 1.35208062384E-06 1.37939467326E-06 1.40726051162E-06 1.43568928614E-06 1.46469236923E-06 1.49428136308E-06 1.52446810427E-06 1.55526466850E-06 1.58668337544E-06 1.61873679365E-06 1.65143774560E-06 1.68479931283E-06 1.71883484115E-06 1.75355794599E-06 1.78898251786E-06 1.82512272790E-06 1.86199303355E-06 1.89960818432E-06 1.93798322772E-06 1.97713351525E-06 2.01707470858E-06 2.05782278577E-06 2.09939404771E-06 2.14180512460E-06 2.18507298265E-06 2.22921493081E-06 2.27424862775E-06 2.32019208890E-06 2.36706369366E-06 2.41488219277E-06 2.46366671577E-06 2.51343677873E-06 2.56421229197E-06 2.61601356809E-06 2.66886133008E-06 2.72277671961E-06 2.77778130549E-06 2.83389709230E-06 2.89114652920E-06 2.94955251891E-06 3.00913842688E-06 3.06992809063E-06 3.13194582929E-06 3.19521645335E-06 3.25976527457E-06 3.32561811611E-06 3.39280132286E-06 3.46134177202E-06 3.53126688381E-06 3.60260463246E-06 3.67538355740E-06 3.74963277470E-06 3.82538198872E-06 3.90266150396E-06 3.98150223724E-06 4.06193573005E-06 4.14399416115E-06 4.22771035950E-06 4.31311781735E-06 4.40025070370E-06 4.48914387790E-06 4.57983290368E-06 4.67235406333E-06 4.76674437224E-06 4.86304159373E-06 4.96128425414E-06 5.06151165828E-06 5.16376390513E-06 5.26808190391E-06 5.37450739046E-06 5.48308294393E-06 5.59385200384E-06 5.70685888746E-06 5.82214880755E-06 5.93976789046E-06 6.05976319461E-06 6.18218272930E-06 6.30707547395E-06 6.43449139771E-06 6.56448147947E-06 6.69709772823E-06 6.83239320396E-06 6.97042203886E-06 7.11123945897E-06 7.25490180634E-06 7.40146656156E-06 7.55099236680E-06 7.70353904925E-06 7.85916764511E-06 8.01794042402E-06 8.17992091398E-06 8.34517392681E-06 8.51376558411E-06 8.68576334371E-06 8.86123602669E-06 9.04025384497E-06 9.22288842939E-06 9.40921285842E-06 9.59930168743E-06 9.79323097854E-06 9.99107833109E-06 1.01929229127E-05 1.03988454910E-05 1.06089284661E-05 1.08232559032E-05 1.10419135668E-05 1.12649889548E-05 1.14925713332E-05 1.17247517727E-05 1.19616231844E-05 1.22032803573E-05 1.24498199964E-05 1.27013407613E-05 1.29579433057E-05 1.32197303180E-05 1.34868065620E-05 1.37592789193E-05 1.40372564319E-05 1.43208503459E-05 1.46101741562E-05 1.49053436518E-05 1.52064769626E-05 1.55136946061E-05 1.58271195364E-05 1.61468771930E-05 1.64730955513E-05 1.68059051737E-05 1.71454392624E-05 1.74918337121E-05 1.78452271651E-05 1.82057610667E-05 1.85735797217E-05 1.89488303525E-05 1.93316631581E-05 1.97222313743E-05 2.01206913350E-05 2.05272025352E-05 2.09419276947E-05 2.13650328237E-05 2.17966872889E-05 2.22370638820E-05 2.26863388883E-05 2.31446921583E-05 2.36123071791E-05 2.40893711486E-05 2.45760750500E-05 2.50726137291E-05 2.55791859720E-05 2.60959945852E-05 2.66232464765E-05 2.71611527389E-05 2.77099287345E-05 2.82697941813E-05 2.88409732417E-05 2.94236946118E-05 3.00181916139E-05 3.06247022899E-05 3.12434694969E-05 3.18747410047E-05 3.25187695954E-05 3.31758131650E-05 3.38461348269E-05 3.45300030176E-05 3.52276916045E-05 3.59394799964E-05 3.66656532549E-05 3.74065022099E-05 3.81623235758E-05 3.89334200714E-05 3.97201005410E-05 4.05226800789E-05 4.13414801560E-05 4.21768287492E-05 4.30290604731E-05 4.38985167150E-05 4.47855457715E-05 4.56905029894E-05 4.66137509084E-05 4.75556594067E-05 4.85166058503E-05 4.94969752446E-05 5.04971603896E-05 5.15175620378E-05 5.25585890558E-05 5.36206585890E-05 5.47041962293E-05 5.58096361868E-05 5.69374214646E-05 5.80880040376E-05 5.92618450341E-05 6.04594149224E-05 6.16811936996E-05 6.29276710859E-05 6.41993467217E-05 6.54967303691E-05 6.68203421177E-05 6.81707125943E-05 6.95483831770E-05 7.09539062139E-05 7.23878452459E-05 7.38507752341E-05 7.53432827922E-05 7.68659664235E-05 7.84194367624E-05 8.00043168212E-05 8.16212422421E-05 8.32708615538E-05 8.49538364340E-05 8.66708419768E-05 8.84225669659E-05 9.02097141528E-05 9.20330005420E-05 9.38931576804E-05 9.57909319539E-05 9.77270848896E-05 9.97023934640E-05 1.01717650418E-04 1.03773664579E-04 1.05871261185E-04 1.08011282226E-04 1.10194586780E-04 1.12422051360E-04 1.14694570278E-04 1.17013056000E-04 1.19378439518E-04 1.21791670731E-04 1.24253718829E-04 1.26765572688E-04 1.29328241269E-04 1.31942754032E-04 1.34610161352E-04 1.37331534950E-04 1.40107968323E-04 1.42940577197E-04 1.45830499974E-04 1.48778898203E-04 1.51786957047E-04 1.54855885771E-04 1.57986918233E-04 1.61181313388E-04 1.64440355804E-04 1.67765356180E-04 1.71157651892E-04 1.74618607531E-04 1.78149615464E-04 1.81752096405E-04 1.85427499994E-04 1.89177305392E-04 1.93003021888E-04 1.96906189516E-04 2.00888379686E-04 2.04951195832E-04 2.09096274065E-04 2.13325283850E-04 2.17639928689E-04 2.22041946822E-04 2.26533111945E-04 2.31115233932E-04 2.35790159590E-04 2.40559773415E-04 2.45425998366E-04 2.50390796667E-04 2.55456170607E-04 2.60624163374E-04 2.65896859897E-04 2.71276387708E-04 2.76764917822E-04 2.82364665639E-04 2.88077891856E-04 2.93906903413E-04 2.99854054441E-04 3.05921747247E-04 3.12112433308E-04 3.18428614292E-04 3.24872843098E-04 3.31447724922E-04 3.38155918341E-04 3.45000136420E-04 3.51983147849E-04 3.59107778096E-04 3.66376910593E-04 3.73793487938E-04 3.81360513131E-04 3.89081050830E-04 3.96958228644E-04 4.04995238437E-04 4.13195337679E-04 4.21561850811E-04 4.30098170650E-04 4.38807759815E-04 4.47694152193E-04 4.56760954430E-04 4.66011847459E-04 4.75450588053E-04 4.85081010427E-04 4.94907027855E-04 5.04932634341E-04 5.15161906313E-04 5.25599004362E-04 5.36248175013E-04 5.47113752541E-04 5.58200160821E-04 5.69511915223E-04 5.81053624545E-04 5.92829992995E-04 6.04845822205E-04 6.17106013304E-04 6.29615569024E-04 6.42379595861E-04 6.55403306281E-04 6.68692020975E-04 6.82251171164E-04 6.96086300956E-04 7.10203069756E-04 7.24607254728E-04 7.39304753316E-04 7.54301585816E-04 7.69603898014E-04 7.85217963873E-04 8.01150188288E-04 8.17407109906E-04 8.33995403997E-04 8.50921885407E-04 8.68193511564E-04 8.85817385561E-04 9.03800759307E-04 9.22151036748E-04 9.40875777165E-04 9.59982698546E-04 9.79479681037E-04 9.99374770470E-04 1.01967618198E-03 1.04039230368E-03 1.06153170048E-03 1.08310311792E-03 1.10511548614E-03 1.12757792394E-03 1.15049974292E-03 1.17389045171E-03 1.19775976036E-03 1.22211758472E-03 1.24697405105E-03 1.27233950064E-03 1.29822449460E-03 1.32463981874E-03 1.35159648857E-03 1.37910575442E-03 1.40717910668E-03 1.43582828117E-03 1.46506526463E-03 1.49490230038E-03 1.52535189407E-03 1.55642681956E-03 1.58814012503E-03 1.62050513913E-03 1.65353547736E-03 1.68724504857E-03 1.72164806162E-03 1.75675903223E-03 1.79259278997E-03 1.82916448545E-03 1.86648959764E-03 1.90458394147E-03 1.94346367549E-03 1.98314530984E-03 2.02364571435E-03 2.06498212688E-03 2.10717216184E-03 2.15023381897E-03 2.19418549228E-03 2.23904597930E-03 2.28483449050E-03 2.33157065897E-03 2.37927455039E-03 2.42796667318E-03 2.47766798899E-03 2.52839992340E-03 2.58018437699E-03 2.63304373655E-03 2.68700088676E-03 2.74207922205E-03 2.79830265881E-03 2.85569564794E-03 2.91428318775E-03 2.97409083713E-03 3.03514472914E-03 3.09747158498E-03 3.16109872822E-03 3.22605409960E-03 3.29236627202E-03 3.36006446613E-03 3.42917856621E-03 3.49973913657E-03 3.57177743831E-03 3.64532544667E-03 3.72041586870E-03 3.79708216158E-03 3.87535855132E-03 3.95528005209E-03 4.03688248596E-03 4.12020250334E-03 4.20527760386E-03 4.29214615799E-03 4.38084742907E-03 4.47142159620E-03 4.56390977757E-03 4.65835405460E-03 4.75479749672E-03 4.85328418683E-03 4.95385924758E-03 5.05656886831E-03 5.16146033285E-03 5.26858204810E-03 5.37798357343E-03 5.48971565094E-03 5.60383023668E-03 5.72038053267E-03 5.83942101995E-03 5.96100749261E-03 6.08519709276E-03 6.21204834663E-03 6.34162120170E-03 6.47397706492E-03 6.60917884215E-03 6.74729097871E-03 6.88837950120E-03 7.03251206060E-03 7.17975797662E-03 7.33018828346E-03 7.48387577691E-03 7.64089506297E-03 7.80132260788E-03 7.96523678975E-03 8.13271795170E-03 8.30384845679E-03 8.47871274446E-03 8.65739738891E-03 8.83999115914E-03 9.02658508100E-03 9.21727250105E-03 9.41214915253E-03 9.61131322336E-03 9.81486542625E-03 1.00229090711E-02 1.02355501395E-02 1.04528973620E-02 1.06750622973E-02 1.09021594144E-02 1.11343061771E-02 1.13716231311E-02 1.16142339947E-02 1.18622657509E-02 1.21158487442E-02 1.23751167791E-02 1.26402072222E-02 1.29112611085E-02 1.31884232495E-02 1.34718423460E-02 1.37616711043E-02 1.40580663559E-02 1.43611891814E-02 1.46712050380E-02 1.49882838920E-02 1.53126003545E-02 1.56443338225E-02 1.59836686238E-02 1.63307941676E-02 1.66859050991E-02 1.70492014595E-02 1.74208888516E-02 1.78011786104E-02 1.81902879793E-02 1.85884402926E-02 1.89958651633E-02 1.94127986775E-02 1.98394835953E-02 2.02761695580E-02 2.07231133024E-02 2.11805788817E-02 2.16488378946E-02 2.21281697209E-02 2.26188617656E-02 2.31212097107E-02 2.36355177755E-02 2.41620989853E-02 2.47012754492E-02 2.52533786466E-02 2.58187497239E-02 2.63977398000E-02 2.69907102829E-02 2.75980331958E-02 2.82200915143E-02 2.88572795151E-02 2.95100031350E-02 3.01786803431E-02 3.08637415241E-02 3.15656298744E-02 3.22848018116E-02 3.30217273964E-02 3.37768907698E-02 3.45507906023E-02 3.53439405601E-02 3.61568697843E-02 3.69901233873E-02 3.78442629637E-02 3.87198671192E-02 3.96175320149E-02 4.05378719303E-02 4.14815198439E-02 4.24491280318E-02 4.34413686862E-02 4.44589345529E-02 4.55025395892E-02 4.65729196421E-02 4.76708331488E-02 4.87970618576E-02 4.99524115730E-02 5.11377129223E-02 5.23538221467E-02 5.36016219171E-02 5.48820221739E-02 5.61959609933E-02 5.75444054795E-02 5.89283526835E-02 6.03488305503E-02 6.18068988934E-02 6.33036503991E-02 6.48402116599E-02 6.64177442383E-02 6.80374457613E-02 6.97005510471E-02 7.14083332637E-02 7.31621051204E-02 7.49632200932E-02 7.68130736843E-02 7.87131047166E-02 8.06647966641E-02 8.26696790176E-02 8.47293286882E-02 8.68453714478E-02 8.90194834072E-02 9.12533925332E-02 9.35488802047E-02 9.59077828076E-02 9.83319933705E-02 1.00823463240E-01 1.03384203798E-01 1.06016288216E-01 1.08721853258E-01 1.11503101117E-01 1.14362301298E-01 1.17301792540E-01 1.20323984782E-01 1.23431361170E-01 1.26626480100E-01 1.29911977312E-01 1.33290568016E-01 1.36765049063E-01 1.40338301153E-01 1.44013291082E-01 1.47793074026E-01 1.51680795868E-01 1.55679695552E-01 1.59793107473E-01 1.64024463906E-01 1.68377297458E-01 1.72855243554E-01 1.77462042947E-01 1.82201544250E-01 1.87077706498E-01 1.92094601719E-01 1.97256417524E-01 2.02567459713E-01 2.08032154878E-01 2.13655053025E-01 2.19440830179E-01 2.25394290995E-01 2.31520371354E-01 2.37824140941E-01 2.44310805801E-01 2.50985710867E-01 2.57854342448E-01 2.64922330677E-01 2.72195451902E-01 2.79679631023E-01 2.87380943748E-01 2.95305618782E-01 3.03460039915E-01 3.11850748012E-01 3.20484442897E-01 3.29367985094E-01 3.38508397452E-01 3.47912866597E-01 3.57588744228E-01 3.67543548229E-01 3.77784963577E-01 3.88320843041E-01 3.99159207642E-01 4.10308246859E-01 4.21776318570E-01 4.33571948690E-01 4.45703830498E-01 4.58180823631E-01 4.71011952711E-01 4.84206405585E-01 4.97773531165E-01 5.11722836813E-01 5.26063985279E-01 5.40806791134E-01 5.55961216681E-01 5.71537367319E-01 5.87545486317E-01 6.03995948971E-01 6.20899256113E-01 6.38266026936E-01 6.56106991096E-01 6.74432980067E-01 6.93254917695E-01 7.12583809933E-01 7.32430733707E-01 7.52806824876E-01 7.73723265254E-01 7.95191268652E-01 8.17222065899E-01 8.39826888804E-01 8.63016953027E-01 8.86803439811E-01 9.11197476543E-01 9.36210116108E-01 9.61852314997E-01 9.88134910136E-01 1.01506859440E+00 1.04266389079E+00 1.07093112521E+00 1.09988039791E+00 1.12952155340E+00 1.15986414900E+00 1.19091742189E+00 1.22269025471E+00 1.25519113960E+00 1.28842814081E+00 1.32240885582E+00 1.35714037489E+00 1.39262923921E+00 1.42888139751E+00 1.46590216137E+00 1.50369615890E+00 1.54226728729E+00 1.58161866386E+00 1.62175257599E+00 1.66267042972E+00 1.70437269737E+00 1.74685886407E+00 1.79012737337E+00 1.83417557204E+00 1.87899965427E+00 1.92459460518E+00 1.97095414409E+00 2.01807066751E+00 2.06593519207E+00 2.11453729765E+00 2.16386507088E+00 2.21390504925E+00 2.26464216602E+00 2.31605969632E+00 2.36813920455E+00 2.42086049354E+00 2.47420155558E+00 2.52813852592E+00 2.58264563872E+00 2.63769518618E+00 2.69325748088E+00 2.74930082197E+00 2.80579146538E+00 2.86269359864E+00 2.91996932059E+00 2.97757862642E+00 3.03547939846E+00 3.09362740319E+00 3.15197629478E+00 3.21047762571E+00 3.26908086470E+00 3.32773342259E+00 3.38638068633E+00 3.44496606159E+00 3.50343102427E+00 3.56171518133E+00 3.61975634110E+00 3.67749059349E+00 3.73485240023E+00 3.79177469537E+00 3.84818899617E+00 3.90402552446E+00 3.95921333860E+00 4.01368047588E+00 4.06735410534E+00 4.12016069092E+00 4.17202616457E+00 4.22287610918E+00 4.27263595077E+00 4.32123115961E+00 4.36858745973E+00 4.41463104598E+00 4.45928880818E+00 4.50248856139E+00 4.54415928134E+00 4.58423134423E+00 4.62263676958E+00 4.65930946521E+00 4.69418547290E+00 4.72720321354E+00 4.75830373038E+00 4.78743092896E+00 4.81453181217E+00 4.83955670897E+00 4.86245949525E+00 4.88319780520E+00 4.90173323163E+00 4.91803151376E+00 4.93206271078E+00 4.94380135983E+00 4.95322661696E+00 4.96032237949E+00 4.96507738878E+00 4.96748531194E+00 4.96754480159E+00 4.96525953258E+00 4.96063821504E+00 4.95369458285E+00 4.94444735729E+00 4.93292018533E+00 4.91914155259E+00 4.90314467093E+00 4.88496734083E+00 4.86465178917E+00 4.84224448279E+00 4.81779591882E+00 4.79136039268E+00 4.76299574482E+00 4.73276308774E+00 4.70072651459E+00 4.66695279105E+00 4.63151103233E+00 4.59447236718E+00 4.55590959086E+00 4.51589680946E+00 4.47450907751E+00 4.43182203157E+00 4.38791152197E+00 4.34285324537E+00 4.29672238074E+00 4.24959323125E+00 4.20153887502E+00 4.15263082731E+00 4.10293871687E+00 4.05252997950E+00 4.00146957127E+00 3.94981970431E+00 3.89763960779E+00 3.84498531650E+00 3.79190948947E+00 3.73846126048E+00 3.68468612244E+00 3.63062584659E+00 3.57631843755E+00 3.52179812405E+00 3.46709538490E+00 3.41223700849E+00 3.35724618343E+00 3.30214261676E+00 3.24694267495E+00 3.19165954188E+00 3.13630338672E+00 3.08088153337E+00 3.02539862227E+00 2.96985675417E+00 2.91425560495E+00 2.85860037163E+00 2.80292594793E+00 2.74727422013E+00 2.69168628237E+00 2.63620239016E+00 2.58086191638E+00 2.52570330967E+00 2.47076405536E+00 2.41608063880E+00 2.36168851135E+00 2.30762205884E+00 2.25391457259E+00 2.20059822311E+00 2.14770403634E+00 2.09526187236E+00 2.04330040667E+00 1.99184711403E+00 1.94092825479E+00 1.89056886374E+00 1.84079274137E+00 1.79162244754E+00 1.74307929753E+00 1.69517894212E+00 1.64794474314E+00 1.60139428318E+00 1.55554390704E+00 1.51040872895E+00 1.46600264191E+00 1.42233832893E+00 1.37942727621E+00 1.33727978818E+00 1.29590500436E+00 1.25531091792E+00 1.21550439588E+00 1.17649120085E+00 1.13827601434E+00 1.10086246139E+00 1.06425313654E+00 1.02844963113E+00 9.93452561641E-01 9.59261599148E-01 9.25875499790E-01 8.93292136083E-01 8.61508529058E-01 8.30520881100E-01 8.00324609407E-01 7.70914379969E-01 7.42284141983E-01 7.14427162596E-01 6.87336061897E-01 6.61002848059E-01 6.35418952535E-01 6.10575265229E-01 5.86462169537E-01 5.63069577185E-01 5.40386962773E-01 5.18403397936E-01 4.97107585059E-01 4.76487890452E-01 4.56532376920E-01 4.37228835669E-01 4.18564817463E-01 4.00527662989E-01 3.83104532373E-01 3.66282433779E-01 3.50048251081E-01 3.34388770526E-01 3.19290706386E-01 3.04740725552E-01 2.90725471057E-01 2.77231584493E-01 2.64245727325E-01 2.51754601084E-01 2.39744966438E-01 2.28203661138E-01 2.17117616852E-01 2.06473874886E-01 1.96259600815E-01 1.86462098043E-01 1.77068820297E-01 1.68067383107E-01 1.59445574269E-01 1.51191363347E-01 1.43292910230E-01 1.35738572788E-01 1.28516913659E-01 1.21616706205E-01 1.15026939682E-01 1.08736823649E-01 1.02735791683E-01 9.70135044067E-02 9.15598518998E-02 8.63649555180E-02 8.14191691629E-02 7.67130800430E-02 7.22375089650E-02 6.79835101889E-02 6.39423708864E-02 6.01056102343E-02 5.64649781761E-02 5.30124538830E-02 4.97402439425E-02 4.66407803026E-02 4.37067179958E-02 4.09309326674E-02 3.83065179276E-02 3.58267825491E-02 3.34852475259E-02 3.12756430104E-02 2.91919051421E-02 2.72281727813E-02 2.53787841582E-02 2.36382734481E-02 2.20013672797E-02 2.04629811859E-02 1.90182160020E-02 1.76623542177E-02 1.63908562873E-02 1.51993569038E-02 1.40836612382E-02 1.30397411509E-02 1.20637313746E-02 1.11519256758E-02 1.03007729941E-02 9.50687356541E-03 8.76697502948E-03 8.07796852690E-03 7.43688478736E-03 6.84089021311E-03 6.28728296105E-03 5.77348902695E-03 5.29705833587E-03 4.85566084259E-03 4.44708264626E-03 4.06922212367E-03 3.72008608534E-03 3.39778595912E-03 3.10053400564E-03 2.82663957040E-03 2.57450537685E-03 2.34262386513E-03 2.12957358080E-03 1.93401561803E-03 1.75469012135E-03 1.59041285008E-03 1.44007180927E-03 1.30262395075E-03 1.17709194785E-03 1.06256104673E-03 9.58175997386E-04 8.63138066860E-04 7.76702136915E-04 6.98173888257E-04 6.26907072946E-04 5.62300876382E-04 5.03797369952E-04 4.50879055082E-04 4.03066499174E-04 3.59916063573E-04 3.21017723454E-04 2.85992979232E-04 2.54492858817E-04 2.26196009827E-04 2.00806880589E-04 1.78053988568E-04 1.57688274663E-04 1.39481541591E-04 1.23224974459E-04 1.08727741417E-04 9.58156722023E-05 8.43300122351E-05 7.41262498344E-05 6.50730140474E-05 5.70510405106E-05 4.99522027147E-05 4.36786060083E-05 3.81417416543E-05 3.32616982463E-05 2.89664277960E-05 2.51910638212E-05 2.18772887909E-05 1.89727483226E-05 1.64305095732E-05 1.42085613216E-05 1.22693533014E-05 1.05793724127E-05 9.10875351509E-06 7.83092258252E-06 6.72227008399E-06 5.76185253597E-06 4.93112026638E-06 4.21366951201E-06 3.59501706471E-06 3.06239577052E-06 2.60456927585E-06 2.21166450357E-06 1.87502042903E-06 1.58705181242E-06 1.34112662694E-06 1.13145600440E-06 9.52995598183E-07 8.01357339786E-07 6.72730638055E-07 5.63812140278E-07 4.71743240828E-07 3.94054586541E-07 3.28616888041E-07 2.73597402955E-07 2.27421510396E-07 1.88738846298E-07 1.56388862303E-07 1.29342989083E-07 1.06770534301E-07 8.79676626825E-08 7.23351501346E-08 5.93638312676E-08 4.86219171761E-08 3.97439657374E-08 3.24213088869E-08 2.63937617040E-08 2.14424567500E-08 1.73836640616E-08 1.40634726152E-08 1.13532230505E-08 9.14559407358E-09 7.35125634985E-09 5.89601793800E-09 4.71839450601E-09 3.76754578616E-09 3.00152705705E-09 2.38581096586E-09 1.89204079185E-09 1.49698137544E-09 1.18163845929E-09 9.30521168197E-10 7.31025848988E-10 5.72922550604E-10 4.47928095775E-10 3.49352021022E-10 2.71803681072E-10 2.10950562183E-10 1.63319358587E-10 1.26132666174E-10 9.71752637157E-11 7.46849075355E-11 5.72633814043E-11 4.38042379997E-11 3.34342578183E-11 2.54661504298E-11 1.93604440740E-11 1.46948639380E-11 1.11397967359E-11 8.43868788651E-12 6.39242499669E-12 4.82838706027E-12 3.63639969253E-12 2.73062145698E-12 2.04436699262E-12 1.52598650609E-12 1.13559602023E-12 8.42490667913E-13 6.23104667431E-13 4.59407460117E-13 3.37646727437E-13 2.47366395649E-13 1.80641930329E-13 1.31486768296E-13 9.53930930423E-14 6.89777195923E-14 4.97099402978E-14 3.57030646994E-14 2.55552886311E-14 1.82286356780E-14 1.29571806552E-14 9.17771523124E-15 6.47755256141E-15 4.55537411664E-15 3.19196534369E-15 2.22842189782E-15 1.54997880476E-15 1.07405616382E-15 7.41454918093E-16 5.09897057844E-16 3.49304004613E-16 2.38358730500E-16 1.62012294036E-16 1.09682435486E-16 7.39572969237E-17 4.96663511193E-17 3.32172009213E-17 2.21240923261E-17 1.46740993963E-17 9.69176222093E-18 6.37383615061E-18 4.17375791246E-18 2.72121596159E-18 1.76640037048E-18 1.14152773007E-18 7.34404908995E-19 4.70345370249E-19 2.99854510852E-19 1.90281569591E-19 1.20186338243E-19 7.55553693843E-20 4.72723095052E-20 2.94346424778E-20 1.82389636548E-20 1.12463029568E-20 6.90027172954E-21 4.21257604449E-21 2.55877791260E-21 1.54631733960E-21 9.29658712599E-22 5.56012832486E-22 3.30795567153E-22 1.95760540394E-22 1.15227998764E-22 6.74582114209E-23 3.92764183328E-23 2.27418221642E-23 1.30945567829E-23 7.49728640130E-24 4.26815812564E-24 2.41587856176E-24 1.35951107005E-24 7.60567987439E-25 4.22975606468E-25 2.33823776889E-25 1.28478930609E-25 7.01646894143E-26 3.80822015751E-26 2.05407009607E-26 1.10095862851E-26 5.86356504238E-27 3.10284232601E-27 1.63131115127E-27 8.52049221226E-28 4.42094082673E-28 2.27854667810E-28 1.16644736764E-28 5.93071207705E-29 2.99469914766E-29 1.50166864551E-29 7.47720296933E-30 3.69672931592E-30 1.81459007688E-30 8.84281361794E-31 4.27781321306E-31 2.05418994330E-31 9.79071755567E-32 4.63138591663E-32 2.17418752446E-32 1.01283647335E-32 4.68170838944E-33 2.14712897093E-33 9.76936556717E-34 4.40955143917E-34 1.97427345531E-34 8.76737751492E-35 3.86141009467E-35 1.68655271620E-35 7.30458044669E-36 3.13686060900E-36 1.33555755497E-36 5.63715429219E-37 2.35857269360E-37 9.78120510025E-38 4.02022685146E-38 1.63751316513E-38 6.60930274333E-39 2.64315881083E-39 1.04724284022E-39 4.11043163136E-40 1.59809390342E-40 6.15390140445E-41 2.34687666402E-41 8.86296822517E-42 3.31416849999E-42 1.22696815222E-42 4.49688434712E-43 1.63142022868E-43 5.85802465098E-44 2.08172260356E-44 7.32041099049E-45 2.54708355021E-45 8.76798410808E-46 2.98578412161E-46 1.00570804144E-46 3.35036880450E-47 1.10375405549E-47 3.59552534148E-48 1.15801342903E-48 3.68702767892E-49 1.16038103465E-49 3.60940508528E-50 1.10950754054E-50 3.37002291301E-51 1.01132612888E-51 2.99814527001E-52 8.77938202675E-53 2.53905015832E-53 7.25137486621E-54 2.04482580577E-54 5.69277147566E-55 1.56446801266E-55 4.24354292569E-56 1.13593213821E-56 3.00040843261E-57 7.81905591770E-58 2.01008940465E-58 5.09687655090E-59 1.27456067445E-59 3.14285210197E-60 7.64070030527E-61 1.83116013238E-61 4.32554610572E-62 1.00696395605E-62 2.30983802543E-63 5.22010658986E-64 1.16209714322E-64 2.54803292629E-65 5.50174983367E-66 1.16966861794E-66 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 TDDFPT/Examples/pseudo/C.pbe-rrkjus.UPF0000644000175000017500000066530612341371476016051 0ustar mbamba Generated using Andrea Dal Corso code (rrkj3) Author: Andrea Dal Corso Generation date: unknown Info: C PBE 2s2 2p2 RRKJ3 US 0 The Pseudo was generated with a Non-Relativistic Calculation 1.70000000000E+00 Local Potential cutoff radius nl pn l occ Rcut Rcut US E pseu 2S 1 0 2.00 1.20000000000 1.60000000000 0.00000000000 2S 1 0 0.00 1.20000000000 1.60000000000 0.00000000000 2P 2 1 2.00 1.30000000000 1.70000000000 0.00000000000 2P 2 1 0.00 1.30000000000 1.70000000000 0.00000000000 3D 3 2 -2.00 1.70000000000 1.70000000000 0.00000000000 0 Version Number C Element US Ultrasoft pseudopotential F Nonlinear Core Correction SLA PW PBE PBE PBE Exchange-Correlation functional 4.00000000000 Z valence -10.71556050100 Total energy 0.0000000 0.0000000 Suggested cutoff for wfc and rho 2 Max angular momentum component 627 Number of points in mesh 2 4 Number of Wavefunctions, Number of Projectors Wavefunctions nl l occ 2S 0 2.00 2P 1 2.00 8.29784472798E-03 8.42325059152E-03 8.55055172199E-03 8.67977676266E-03 8.81095478973E-03 8.94411531879E-03 9.07928831153E-03 9.21650418245E-03 9.35579380569E-03 9.49718852201E-03 9.64072014581E-03 9.78642097231E-03 9.93432378482E-03 1.00844618621E-02 1.02368689858E-02 1.03915794483E-02 1.05486280599E-02 1.07080501574E-02 1.08698816114E-02 1.10341588345E-02 1.12009187900E-02 1.13701989994E-02 1.15420375516E-02 1.17164731109E-02 1.18935449261E-02 1.20732928390E-02 1.22557572938E-02 1.24409793457E-02 1.26290006705E-02 1.28198635736E-02 1.30136110002E-02 1.32102865441E-02 1.34099344583E-02 1.36125996642E-02 1.38183277625E-02 1.40271650429E-02 1.42391584946E-02 1.44543558170E-02 1.46728054304E-02 1.48945564870E-02 1.51196588816E-02 1.53481632632E-02 1.55801210463E-02 1.58155844224E-02 1.60546063717E-02 1.62972406752E-02 1.65435419266E-02 1.67935655447E-02 1.70473677859E-02 1.73050057568E-02 1.75665374270E-02 1.78320216422E-02 1.81015181375E-02 1.83750875507E-02 1.86527914362E-02 1.89346922785E-02 1.92208535063E-02 1.95113395074E-02 1.98062156421E-02 2.01055482589E-02 2.04094047088E-02 2.07178533610E-02 2.10309636175E-02 2.13488059296E-02 2.16714518131E-02 2.19989738646E-02 2.23314457781E-02 2.26689423611E-02 2.30115395518E-02 2.33593144360E-02 2.37123452644E-02 2.40707114706E-02 2.44344936884E-02 2.48037737704E-02 2.51786348061E-02 2.55591611408E-02 2.59454383947E-02 2.63375534816E-02 2.67355946292E-02 2.71396513984E-02 2.75498147036E-02 2.79661768334E-02 2.83888314709E-02 2.88178737153E-02 2.92534001028E-02 2.96955086288E-02 3.01442987695E-02 3.05998715046E-02 3.10623293399E-02 3.15317763303E-02 3.20083181035E-02 3.24920618832E-02 3.29831165139E-02 3.34815924850E-02 3.39876019557E-02 3.45012587802E-02 3.50226785335E-02 3.55519785372E-02 3.60892778860E-02 3.66346974746E-02 3.71883600247E-02 3.77503901127E-02 3.83209141978E-02 3.89000606502E-02 3.94879597804E-02 4.00847438681E-02 4.06905471922E-02 4.13055060612E-02 4.19297588433E-02 4.25634459980E-02 4.32067101076E-02 4.38596959093E-02 4.45225503276E-02 4.51954225076E-02 4.58784638483E-02 4.65718280369E-02 4.72756710833E-02 4.79901513551E-02 4.87154296135E-02 4.94516690490E-02 5.01990353187E-02 5.09576965831E-02 5.17278235442E-02 5.25095894839E-02 5.33031703027E-02 5.41087445597E-02 5.49264935125E-02 5.57566011581E-02 5.65992542742E-02 5.74546424612E-02 5.83229581852E-02 5.92043968208E-02 6.00991566955E-02 6.10074391340E-02 6.19294485037E-02 6.28653922605E-02 6.38154809959E-02 6.47799284836E-02 6.57589517286E-02 6.67527710151E-02 6.77616099568E-02 6.87856955465E-02 6.98252582079E-02 7.08805318470E-02 7.19517539048E-02 7.30391654108E-02 7.41430110372E-02 7.52635391538E-02 7.64010018842E-02 7.75556551624E-02 7.87277587902E-02 7.99175764958E-02 8.11253759933E-02 8.23514290427E-02 8.35960115110E-02 8.48594034346E-02 8.61418890819E-02 8.74437570178E-02 8.87653001678E-02 9.01068158849E-02 9.14686060157E-02 9.28509769687E-02 9.42542397833E-02 9.56787101994E-02 9.71247087290E-02 9.85925607278E-02 1.00082596469E-01 1.01595151216E-01 1.03130565301E-01 1.04689184198E-01 1.06271358604E-01 1.07877444513E-01 1.09507803303E-01 1.11162801810E-01 1.12842812416E-01 1.14548213132E-01 1.16279387679E-01 1.18036725578E-01 1.19820622239E-01 1.21631479045E-01 1.23469703447E-01 1.25335709053E-01 1.27229915723E-01 1.29152749660E-01 1.31104643511E-01 1.33086036460E-01 1.35097374328E-01 1.37139109676E-01 1.39211701902E-01 1.41315617348E-01 1.43451329404E-01 1.45619318615E-01 1.47820072786E-01 1.50054087098E-01 1.52321864212E-01 1.54623914388E-01 1.56960755597E-01 1.59332913639E-01 1.61740922258E-01 1.64185323267E-01 1.66666666667E-01 1.69185510769E-01 1.71742422326E-01 1.74337976651E-01 1.76972757758E-01 1.79647358481E-01 1.82362380618E-01 1.85118435059E-01 1.87916141930E-01 1.90756130725E-01 1.93639040455E-01 1.96565519785E-01 1.99536227187E-01 2.02551831082E-01 2.05613009993E-01 2.08720452699E-01 2.11874858387E-01 2.15076936812E-01 2.18327408456E-01 2.21627004687E-01 2.24976467929E-01 2.28376551826E-01 2.31828021411E-01 2.35331653278E-01 2.38888235760E-01 2.42498569103E-01 2.46163465647E-01 2.49883750009E-01 2.53660259270E-01 2.57493843159E-01 2.61385364248E-01 2.65335698148E-01 2.69345733699E-01 2.73416373176E-01 2.77548532491E-01 2.81743141397E-01 2.86001143697E-01 2.90323497462E-01 2.94711175239E-01 2.99165164273E-01 3.03686466732E-01 3.08276099926E-01 3.12935096544E-01 3.17664504879E-01 3.22465389067E-01 3.27338829328E-01 3.32285922207E-01 3.37307780820E-01 3.42405535107E-01 3.47580332084E-01 3.52833336102E-01 3.58165729109E-01 3.63578710916E-01 3.69073499467E-01 3.74651331113E-01 3.80313460888E-01 3.86061162797E-01 3.91895730096E-01 3.97818475587E-01 4.03830731914E-01 4.09933851859E-01 4.16129208651E-01 4.22418196270E-01 4.28802229765E-01 4.35282745571E-01 4.41861201830E-01 4.48539078725E-01 4.55317878804E-01 4.62199127327E-01 4.69184372604E-01 4.76275186344E-01 4.83473164010E-01 4.90779925178E-01 4.98197113899E-01 5.05726399073E-01 5.13369474820E-01 5.21128060864E-01 5.29003902921E-01 5.36998773088E-01 5.45114470244E-01 5.53352820456E-01 5.61715677387E-01 5.70204922715E-01 5.78822466556E-01 5.87570247894E-01 5.96450235017E-01 6.05464425959E-01 6.14614848951E-01 6.23903562877E-01 6.33332657737E-01 6.42904255116E-01 6.52620508665E-01 6.62483604582E-01 6.72495762105E-01 6.82659234012E-01 6.92976307126E-01 7.03449302833E-01 7.14080577600E-01 7.24872523510E-01 7.35827568796E-01 7.46948178390E-01 7.58236854474E-01 7.69696137050E-01 7.81328604504E-01 7.93136874190E-01 8.05123603018E-01 8.17291488054E-01 8.29643267123E-01 8.42181719427E-01 8.54909666171E-01 8.67829971197E-01 8.80945541627E-01 8.94259328520E-01 9.07774327535E-01 9.21493579604E-01 9.35420171616E-01 9.49557237112E-01 9.63907956993E-01 9.78475560230E-01 9.93263324597E-01 1.00827457740E+00 1.02351269624E+00 1.03898110975E+00 1.05468329840E+00 1.07062279524E+00 1.08680318672E+00 1.10322811351E+00 1.11990127127E+00 1.13682641155E+00 1.15400734256E+00 1.17144793010E+00 1.18915209836E+00 1.20712383086E+00 1.22536717132E+00 1.24388622455E+00 1.26268515744E+00 1.28176819981E+00 1.30113964544E+00 1.32080385297E+00 1.34076524695E+00 1.36102831876E+00 1.38159762769E+00 1.40247780191E+00 1.42367353955E+00 1.44518960974E+00 1.46703085370E+00 1.48920218578E+00 1.51170859464E+00 1.53455514431E+00 1.55774697537E+00 1.58128930606E+00 1.60518743352E+00 1.62944673492E+00 1.65407266871E+00 1.67907077584E+00 1.70444668097E+00 1.73020609379E+00 1.75635481028E+00 1.78289871402E+00 1.80984377749E+00 1.83719606344E+00 1.86496172626E+00 1.89314701333E+00 1.92175826647E+00 1.95080192333E+00 1.98028451885E+00 2.01021268674E+00 2.04059316097E+00 2.07143277726E+00 2.10273847467E+00 2.13451729711E+00 2.16677639495E+00 2.19952302661E+00 2.23276456023E+00 2.26650847531E+00 2.30076236434E+00 2.33553393462E+00 2.37083100989E+00 2.40666153213E+00 2.44303356338E+00 2.47995528748E+00 2.51743501198E+00 2.55548116998E+00 2.59410232203E+00 2.63330715804E+00 2.67310449928E+00 2.71350330030E+00 2.75451265101E+00 2.79614177869E+00 2.83840005007E+00 2.88129697343E+00 2.92484220076E+00 2.96904552994E+00 3.01391690688E+00 3.05946642784E+00 3.10570434165E+00 3.15264105204E+00 3.20028711997E+00 3.24865326601E+00 3.29775037273E+00 3.34758948720E+00 3.39818182342E+00 3.44953876490E+00 3.50167186715E+00 3.55459286034E+00 3.60831365192E+00 3.66284632929E+00 3.71820316255E+00 3.77439660720E+00 3.83143930701E+00 3.88934409682E+00 3.94812400547E+00 4.00779225868E+00 4.06836228205E+00 4.12984770410E+00 4.19226235930E+00 4.25562029123E+00 4.31993575567E+00 4.38522322388E+00 4.45149738581E+00 4.51877315344E+00 4.58706566409E+00 4.65639028387E+00 4.72676261111E+00 4.79819847987E+00 4.87071396354E+00 4.94432537839E+00 5.01904928732E+00 5.09490250351E+00 5.17190209425E+00 5.25006538479E+00 5.32940996219E+00 5.40995367931E+00 5.49171465883E+00 5.57471129732E+00 5.65896226937E+00 5.74448653181E+00 5.83130332795E+00 5.91943219194E+00 6.00889295314E+00 6.09970574061E+00 6.19189098761E+00 6.28546943620E+00 6.38046214193E+00 6.47689047856E+00 6.57477614287E+00 6.67414115955E+00 6.77500788615E+00 6.87739901810E+00 6.98133759385E+00 7.08684700001E+00 7.19395097664E+00 7.30267362260E+00 7.41303940092E+00 7.52507314439E+00 7.63880006106E+00 7.75424573996E+00 7.87143615688E+00 7.99039768014E+00 8.11115707658E+00 8.23374151759E+00 8.35817858517E+00 8.48449627820E+00 8.61272301868E+00 8.74288765818E+00 8.87501948429E+00 9.00914822722E+00 9.14530406651E+00 9.28351763780E+00 9.42382003972E+00 9.56624284091E+00 9.71081808709E+00 9.85757830831E+00 1.00065565262E+01 1.01577862616E+01 1.03113015417E+01 1.04671369082E+01 1.06253274246E+01 1.07859086846E+01 1.09489168195E+01 1.11143885068E+01 1.12823609785E+01 1.14528720290E+01 1.16259600240E+01 1.18016639090E+01 1.19800232183E+01 1.21610780833E+01 1.23448692421E+01 1.25314380487E+01 1.27208264816E+01 1.29130771542E+01 1.31082333236E+01 1.33063389008E+01 1.35074384605E+01 1.37115772507E+01 1.39188012037E+01 1.41291569456E+01 1.43426918075E+01 1.45594538356E+01 1.47794918022E+01 1.50028552168E+01 1.52295943371E+01 1.54597601804E+01 1.56934045349E+01 1.59305799717E+01 1.61713398562E+01 1.64157383603E+01 1.66638304749E+01 1.69156720216E+01 1.71713196659E+01 1.74308309295E+01 1.76942642037E+01 1.79616787619E+01 1.82331347736E+01 1.85086933176E+01 1.87884163957E+01 1.90723669467E+01 1.93606088607E+01 1.96532069934E+01 1.99502271806E+01 2.02517362531E+01 2.05578020517E+01 2.08684934425E+01 2.11838803323E+01 2.15040336846E+01 2.18290255351E+01 2.21589290085E+01 2.24938183345E+01 2.28337688644E+01 2.31788570887E+01 2.35291606536E+01 2.38847583789E+01 2.42457302756E+01 2.46121575639E+01 2.49841226915E+01 2.53617093521E+01 2.57450025043E+01 2.61340883907E+01 2.65290545572E+01 2.69299898729E+01 2.73369845500E+01 2.77501301639E+01 2.81695196741E+01 2.85952474452E+01 2.90274092675E+01 2.94661023794E+01 2.99114254886E+01 3.03634787948E+01 3.08223640118E+01 3.12881843907E+01 3.17610447431E+01 3.22410514646E+01 3.27283125586E+01 3.32229376611E+01 3.37250380647E+01 3.42347267441E+01 3.47521183815E+01 3.52773293921E+01 3.58104779507E+01 3.63516840179E+01 3.69010693674E+01 3.74587576131E+01 3.80248742373E+01 3.85995466187E+01 3.91829040609E+01 3.97750778218E+01 4.03762011430E+01 4.09864092798E+01 4.16058395316E+01 4.22346312728E+01 4.28729259843E+01 4.35208672850E+01 4.41786009644E+01 4.48462750154E+01 4.55240396675E+01 4.62120474205E+01 4.69104530792E+01 4.76194137878E+01 4.83390890653E+01 4.90696408418E+01 4.98112334945E+01 5.05640338849E+01 5.13282113962E+01 5.21039379717E+01 5.28913881530E+01 5.36907391197E+01 5.45021707293E+01 5.53258655573E+01 5.61620089383E+01 5.70107890084E+01 5.78723967465E+01 5.87470260180E+01 5.96348736181E+01 6.05361393165E+01 6.14510259016E+01 6.23797392267E+01 6.33224882564E+01 6.42794851130E+01 6.52509451250E+01 6.62370868749E+01 6.72381322488E+01 6.82543064861E+01 6.92858382303E+01 7.03329595805E+01 7.13959061432E+01 7.24749170861E+01 7.35702351910E+01 7.46821069092E+01 7.58107824166E+01 7.69565156698E+01 7.81195644637E+01 7.93001904892E+01 8.04986593921E+01 8.17152408330E+01 8.29502085478E+01 8.42038404095E+01 8.54764184905E+01 8.67682291262E+01 8.80795629796E+01 8.94107151062E+01 9.07619850210E+01 9.21336767653E+01 9.35260989755E+01 9.49395649526E+01 9.63743927323E+01 9.78309051570E+01 9.93094299480E+01 1.24467670920E-04 1.26348758873E-04 1.28258275830E-04 1.30196651440E-04 1.32164321846E-04 1.34161729782E-04 1.36189324673E-04 1.38247562737E-04 1.40336907085E-04 1.42457827830E-04 1.44610802187E-04 1.46796314585E-04 1.49014856772E-04 1.51266927931E-04 1.53553034788E-04 1.55873691724E-04 1.58229420899E-04 1.60620752361E-04 1.63048224170E-04 1.65512382518E-04 1.68013781849E-04 1.70552984991E-04 1.73130563273E-04 1.75747096663E-04 1.78403173891E-04 1.81099392586E-04 1.83836359408E-04 1.86614690186E-04 1.89435010057E-04 1.92297953605E-04 1.95204165003E-04 1.98154298162E-04 2.01149016874E-04 2.04188994963E-04 2.07274916438E-04 2.10407475643E-04 2.13587377418E-04 2.16815337254E-04 2.20092081456E-04 2.23418347304E-04 2.26794883224E-04 2.30222448948E-04 2.33701815695E-04 2.37233766337E-04 2.40819095576E-04 2.44458610128E-04 2.48153128899E-04 2.51903483171E-04 2.55710516789E-04 2.59575086352E-04 2.63498061405E-04 2.67480324633E-04 2.71522772062E-04 2.75626313261E-04 2.79791871543E-04 2.84020384177E-04 2.88312802595E-04 2.92670092610E-04 2.97093234631E-04 3.01583223883E-04 3.06141070632E-04 3.10767800414E-04 3.15464454263E-04 3.20232088944E-04 3.25071777196E-04 3.29984607970E-04 3.34971686672E-04 3.40034135417E-04 3.45173093277E-04 3.50389716540E-04 3.55685178966E-04 3.61060672059E-04 3.66517405326E-04 3.72056606555E-04 3.77679522091E-04 3.83387417112E-04 3.89181575920E-04 3.95063302224E-04 4.01033919438E-04 4.07094770975E-04 4.13247220554E-04 4.19492652500E-04 4.25832472064E-04 4.32268105729E-04 4.38801001542E-04 4.45432629432E-04 4.52164481543E-04 4.58998072569E-04 4.65934940099E-04 4.72976644955E-04 4.80124771552E-04 4.87380928248E-04 4.94746747709E-04 5.02223887276E-04 5.09814029336E-04 5.17518881703E-04 5.25340178002E-04 5.33279678057E-04 5.41339168290E-04 5.49520462119E-04 5.57825400371E-04 5.66255851691E-04 5.74813712967E-04 5.83500909753E-04 5.92319396705E-04 6.01271158021E-04 6.10358207884E-04 6.19582590918E-04 6.28946382649E-04 6.38451689970E-04 6.48100651615E-04 6.57895438640E-04 6.67838254915E-04 6.77931337614E-04 6.88176957724E-04 6.98577420554E-04 7.09135066249E-04 7.19852270327E-04 7.30731444202E-04 7.41775035735E-04 7.52985529781E-04 7.64365448747E-04 7.75917353164E-04 7.87643842259E-04 7.99547554541E-04 8.11631168396E-04 8.23897402688E-04 8.36349017372E-04 8.48988814112E-04 8.61819636918E-04 8.74844372778E-04 8.88065952312E-04 9.01487350433E-04 9.15111587010E-04 9.28941727555E-04 9.42980883908E-04 9.57232214938E-04 9.71698927254E-04 9.86384275929E-04 1.00129156523E-03 1.01642414935E-03 1.03178543320E-03 1.04737887312E-03 1.06320797771E-03 1.07927630857E-03 1.09558748116E-03 1.11214516556E-03 1.12895308731E-03 1.14601502826E-03 1.16333482744E-03 1.18091638185E-03 1.19876364744E-03 1.21688063990E-03 1.23527143564E-03 1.25394017267E-03 1.27289105152E-03 1.29212833623E-03 1.31165635527E-03 1.33147950252E-03 1.35160223827E-03 1.37202909024E-03 1.39276465453E-03 1.41381359675E-03 1.43518065299E-03 1.45687063093E-03 1.47888841092E-03 1.50123894703E-03 1.52392726824E-03 1.54695847952E-03 1.57033776297E-03 1.59407037905E-03 1.61816166770E-03 1.64261704954E-03 1.66744202715E-03 1.69264218625E-03 1.71822319698E-03 1.74419081518E-03 1.77055088367E-03 1.79730933358E-03 1.82447218567E-03 1.85204555170E-03 1.88003563580E-03 1.90844873584E-03 1.93729124490E-03 1.96656965267E-03 1.99629054690E-03 2.02646061493E-03 2.05708664514E-03 2.08817552853E-03 2.11973426022E-03 2.15176994106E-03 2.18428977922E-03 2.21730109179E-03 2.25081130647E-03 2.28482796318E-03 2.31935871582E-03 2.35441133396E-03 2.38999370458E-03 2.42611383387E-03 2.46277984901E-03 2.50000000000E-03 2.53778266154E-03 2.57613633488E-03 2.61506964977E-03 2.65459136636E-03 2.69471037721E-03 2.73543570926E-03 2.77677652589E-03 2.81874212895E-03 2.86134196088E-03 2.90458560682E-03 2.94848279678E-03 2.99304340780E-03 3.03827746622E-03 3.08419514989E-03 3.13080679048E-03 3.17812287580E-03 3.22615405218E-03 3.27491112683E-03 3.32440507030E-03 3.37464701894E-03 3.42564827739E-03 3.47742032116E-03 3.52997479917E-03 3.58332353640E-03 3.63747853655E-03 3.69245198471E-03 3.74825625014E-03 3.80490388905E-03 3.86240764738E-03 3.92078046373E-03 3.98003547222E-03 4.04018600548E-03 4.10124559764E-03 4.16322798736E-03 4.22614712095E-03 4.29001715546E-03 4.35485246194E-03 4.42066762858E-03 4.48747746410E-03 4.55529700098E-03 4.62414149890E-03 4.69402644816E-03 4.76496757318E-03 4.83698083601E-03 4.91008243992E-03 4.98428883311E-03 5.05961671231E-03 5.13608302661E-03 5.21370498126E-03 5.29250004153E-03 5.37248593664E-03 5.45368066375E-03 5.53610249201E-03 5.61976996669E-03 5.70470191332E-03 5.79091744195E-03 5.87843595144E-03 5.96727713381E-03 6.05746097871E-03 6.14900777789E-03 6.24193812976E-03 6.33627294404E-03 6.43203344647E-03 6.52924118356E-03 6.62791802746E-03 6.72808618087E-03 6.82976818206E-03 6.93298690991E-03 7.03776558906E-03 7.14412779516E-03 7.25209746015E-03 7.36169887766E-03 7.47295670848E-03 7.58589598609E-03 7.70054212230E-03 7.81692091297E-03 7.93505854382E-03 8.05498159632E-03 8.17671705366E-03 8.30029230684E-03 8.42573516080E-03 8.55307384072E-03 8.68233699834E-03 8.81355371841E-03 8.94675352525E-03 9.08196638938E-03 9.21922273426E-03 9.35855344315E-03 9.49998986605E-03 9.64356382674E-03 9.78930762998E-03 9.93725406874E-03 1.00874364316E-02 1.02398885102E-02 1.03946446069E-02 1.05517395425E-02 1.07112086640E-02 1.08730878527E-02 1.10374135319E-02 1.12042226758E-02 1.13735528171E-02 1.15454420557E-02 1.17199290676E-02 1.18970531128E-02 1.20768540453E-02 1.22593723208E-02 1.24446490068E-02 1.26327257914E-02 1.28236449926E-02 1.30174495679E-02 1.32141831244E-02 1.34138899278E-02 1.36166149130E-02 1.38224036941E-02 1.40313025742E-02 1.42433585567E-02 1.44586193549E-02 1.46771334035E-02 1.48989498690E-02 1.51241186610E-02 1.53526904436E-02 1.55847166463E-02 1.58202494760E-02 1.60593419286E-02 1.63020478008E-02 1.65484217026E-02 1.67985190691E-02 1.70523961732E-02 1.73101101384E-02 1.75717189515E-02 1.78372814754E-02 1.81068574629E-02 1.83805075697E-02 1.86582933683E-02 1.89402773616E-02 1.92265229972E-02 1.95170946816E-02 1.98120577946E-02 2.01114787042E-02 2.04154247814E-02 2.07239644153E-02 2.10371670286E-02 2.13551030932E-02 2.16778441462E-02 2.20054628055E-02 2.23380327867E-02 2.26756289196E-02 2.30183271647E-02 2.33662046305E-02 2.37193395909E-02 2.40778115028E-02 2.44417010238E-02 2.48110900307E-02 2.51860616375E-02 2.55667002145E-02 2.59530914068E-02 2.63453221542E-02 2.67434807103E-02 2.71476566623E-02 2.75579409516E-02 2.79744258939E-02 2.83972052000E-02 2.88263739971E-02 2.92620288500E-02 2.97042677827E-02 3.01531903011E-02 3.06088974145E-02 3.10714916589E-02 3.15410771201E-02 3.20177594567E-02 3.25016459242E-02 3.29928453991E-02 3.34914684035E-02 3.39976271296E-02 3.45114354652E-02 3.50330090193E-02 3.55624651483E-02 3.60999229820E-02 3.66455034507E-02 3.71993293122E-02 3.77615251797E-02 3.83322175498E-02 3.89115348305E-02 3.94996073707E-02 4.00965674891E-02 4.07025495045E-02 4.13176897652E-02 4.19421266803E-02 4.25760007510E-02 4.32194546014E-02 4.38726330115E-02 4.45356829490E-02 4.52087536031E-02 4.58919964175E-02 4.65855651247E-02 4.72896157806E-02 4.80043067996E-02 4.87297989901E-02 4.94662555909E-02 5.02138423080E-02 5.09727273514E-02 5.17430814735E-02 5.25250780072E-02 5.33188929051E-02 5.41247047788E-02 5.49426949394E-02 5.57730474382E-02 5.66159491079E-02 5.74715896051E-02 5.83401614524E-02 5.92218600821E-02 6.01168838802E-02 6.10254342307E-02 6.19477155615E-02 6.28839353895E-02 6.38343043684E-02 6.47990363350E-02 6.57783483582E-02 6.67724607872E-02 6.77815973016E-02 6.88059849614E-02 6.98458542581E-02 7.09014391666E-02 7.19729771981E-02 7.30607094531E-02 7.41648806759E-02 7.52857393098E-02 7.64235375526E-02 7.75785314138E-02 7.87509807719E-02 7.99411494328E-02 8.11493051897E-02 8.23757198825E-02 8.36206694599E-02 8.48844340406E-02 8.61672979771E-02 8.74695499192E-02 8.87914828791E-02 9.01333942971E-02 9.14955861092E-02 9.28783648141E-02 9.42820415430E-02 9.57069321289E-02 9.71533571783E-02 9.86216421430E-02 1.00112117393E-01 1.01625118292E-01 1.03160985272E-01 1.04720063908E-01 1.06302705000E-01 1.07909264650E-01 1.09540104339E-01 1.11195591014E-01 1.12876097166E-01 1.14582000916E-01 1.16313686099E-01 1.18071542353E-01 1.19855965202E-01 1.21667356149E-01 1.23506122764E-01 1.25372678778E-01 1.27267444173E-01 1.29190845280E-01 1.31143314873E-01 1.33125292264E-01 1.35137223408E-01 1.37179560998E-01 1.39252764567E-01 1.41357300596E-01 1.43493642614E-01 1.45662271306E-01 1.47863674625E-01 1.50098347894E-01 1.52366793924E-01 1.54669523126E-01 1.57007053623E-01 1.59379911370E-01 1.61788630269E-01 1.64233752292E-01 1.66715827602E-01 1.69235414677E-01 1.71793080435E-01 1.74389400360E-01 1.77024958636E-01 1.79700348274E-01 1.82416171249E-01 1.85173038632E-01 1.87971570730E-01 1.90812397224E-01 1.93696157313E-01 1.96623499854E-01 1.99595083513E-01 2.02611576907E-01 2.05673658761E-01 2.08782018055E-01 2.11937354185E-01 2.15140377113E-01 2.18391807534E-01 2.21692377032E-01 2.25042828251E-01 2.28443915056E-01 2.31896402705E-01 2.35401068024E-01 2.38958699575E-01 2.42570097842E-01 2.46236075405E-01 2.49957457123E-01 2.53735080324E-01 2.57569794988E-01 2.61462463943E-01 2.65413963055E-01 2.69425181429E-01 2.73497021605E-01 2.77630399764E-01 2.81826245935E-01 2.86085504200E-01 2.90409132911E-01 2.94798104902E-01 2.99253407710E-01 3.03776043797E-01 3.08367030775E-01 3.13027401637E-01 3.17758204984E-01 3.22560505268E-01 3.27435383027E-01 3.32383935128E-01 3.37407275017E-01 3.42506532966E-01 3.47682856330E-01 3.52937409804E-01 3.58271375683E-01 3.63685954134E-01 3.69182363459E-01 3.74761840373E-01 3.80425640282E-01 3.86175037565E-01 3.92011325860E-01 3.97935818358E-01 4.03949848094E-01 4.10054768250E-01 4.16251952458E-01 4.22542795112E-01 4.28928711678E-01 4.35411139013E-01 4.41991535691E-01 4.48671382330E-01 4.55452181922E-01 4.62335460177E-01 4.69322765860E-01 4.76415671147E-01 4.83615771969E-01 4.90924688379E-01 4.98344064916E-01 5.05875570970E-01 5.13520901162E-01 5.21281775723E-01 5.29159940882E-01 5.37157169261E-01 5.45275260269E-01 5.53516040510E-01 5.61881364197E-01 5.70373113560E-01 5.78993199280E-01 5.87743560913E-01 5.96626167327E-01 6.05643017145E-01 6.14796139197E-01 6.24087592974E-01 6.33519469093E-01 6.43093889764E-01 6.52813009274E-01 6.62679014466E-01 6.72694125231E-01 6.82860595012E-01 6.93180711308E-01 7.03656796188E-01 7.14291206816E-01 7.25086335979E-01 7.36044612627E-01 7.47168502418E-01 7.58460508274E-01 7.69923170944E-01 7.81559069575E-01 7.93370822295E-01 8.05361086796E-01 8.17532560940E-01 8.29887983359E-01 8.42430134075E-01 8.55161835126E-01 8.68085951197E-01 8.81205390269E-01 8.94523104272E-01 9.08042089747E-01 9.21765388523E-01 9.35696088401E-01 9.49837323845E-01 9.64192276695E-01 9.78764176875E-01 9.93556303123E-01 1.00857198373E+00 1.02381459729E+00 1.03928757345E+00 1.05499439371E+00 1.07093859215E+00 1.08712375629E+00 1.10355352786E+00 1.12023160364E+00 1.13716173625E+00 1.15434773505E+00 1.17179346696E+00 1.18950285734E+00 1.20747989088E+00 1.22572861250E+00 1.24425312822E+00 1.26305760614E+00 1.28214627736E+00 1.30152343689E+00 1.32119344469E+00 1.34116072659E+00 1.36142977531E+00 1.38200515148E+00 1.40289148463E+00 1.42409347429E+00 1.44561589098E+00 1.46746357735E+00 1.48964144922E+00 -2.24894653045E+01 -2.21701640694E+01 -2.18335363904E+01 -2.14936053998E+01 -2.11521325416E+01 -2.08079488611E+01 -2.04629603237E+01 -2.01178271718E+01 -1.97732768645E+01 -1.94302881888E+01 -1.90871874323E+01 -1.87553173556E+01 -1.84058700870E+01 -1.80882895142E+01 -1.77621465393E+01 -1.74346173536E+01 -1.71203924743E+01 -1.68070986973E+01 -1.65044408712E+01 -1.62133220086E+01 -1.59167743857E+01 -1.56397080591E+01 -1.53617024078E+01 -1.50964783762E+01 -1.48366716215E+01 -1.45897196952E+01 -1.43422156966E+01 -1.41135458712E+01 -1.38862856125E+01 -1.36704412668E+01 -1.34616380384E+01 -1.32620820868E+01 -1.30700293356E+01 -1.28885866512E+01 -1.27105167635E+01 -1.25464250267E+01 -1.23798940769E+01 -1.22411767116E+01 -1.20837538204E+01 -1.19565334140E+01 -1.18213688435E+01 -1.17028875745E+01 -1.15752519042E+01 -1.14817894368E+01 -1.13568228389E+01 -1.12796172347E+01 -1.11763308168E+01 -1.10854747887E+01 -1.10162196237E+01 -1.09353680382E+01 -1.08556819791E+01 -1.07945233790E+01 -1.07323439393E+01 -1.06698386254E+01 -1.06199894970E+01 -1.05632166469E+01 -1.05172025070E+01 -1.04711897160E+01 -1.04342117383E+01 -1.03913900234E+01 -1.03566826911E+01 -1.03216643751E+01 -1.02946334328E+01 -1.02625399540E+01 -1.02380266100E+01 -1.02113366549E+01 -1.01907288915E+01 -1.01682656569E+01 -1.01497462318E+01 -1.01313900628E+01 -1.01148033584E+01 -1.00988904415E+01 -1.00854769078E+01 -1.00719328436E+01 -1.00601492788E+01 -1.00492730973E+01 -1.00382280215E+01 -1.00293838045E+01 -1.00202595486E+01 -1.00122571896E+01 -1.00045405655E+01 -9.99770978579E+00 -9.99118860500E+00 -9.98533237416E+00 -9.97941380279E+00 -9.97449606649E+00 -9.96939706410E+00 -9.96519118771E+00 -9.96038146431E+00 -9.95687552778E+00 -9.95286377528E+00 -9.94928302929E+00 -9.94604777685E+00 -9.94265385769E+00 -9.93973652993E+00 -9.93672574438E+00 -9.93402859167E+00 -9.93123954767E+00 -9.92875137061E+00 -9.92616592578E+00 -9.92384269071E+00 -9.92138363666E+00 -9.91918410838E+00 -9.91694139905E+00 -9.91471079490E+00 -9.91260605192E+00 -9.91067748837E+00 -9.90708881595E+00 -9.90803182435E+00 -9.90416843859E+00 -9.90190430156E+00 -9.90080357359E+00 -9.89979735436E+00 -9.89528676493E+00 -9.89528187704E+00 -9.89293956253E+00 -9.89035094510E+00 -9.88987197523E+00 -9.88882004805E+00 -9.88290307079E+00 -9.88631052505E+00 -9.88083928190E+00 -9.88115974416E+00 -9.87769858322E+00 -9.87791916943E+00 -9.87485275998E+00 -9.87368695434E+00 -9.87175932741E+00 -9.87097106182E+00 -9.86833830205E+00 -9.86749289638E+00 -9.86546384757E+00 -9.86410076443E+00 -9.86265999348E+00 -9.86150009681E+00 -9.85966487137E+00 -9.85863456188E+00 -9.85710472073E+00 -9.85572110230E+00 -9.85464670719E+00 -9.85337329623E+00 -9.85212574596E+00 -9.85130938860E+00 -9.84998481384E+00 -9.84899531768E+00 -9.84821984021E+00 -9.84735899586E+00 -9.84639403130E+00 -9.84577951952E+00 -9.84514411648E+00 -9.84447227268E+00 -9.84407154257E+00 -9.84371146424E+00 -9.84332070591E+00 -9.84315500996E+00 -9.84301577866E+00 -9.84308785292E+00 -9.84316167389E+00 -9.84344083798E+00 -9.84379156100E+00 -9.84430900430E+00 -9.84495488247E+00 -9.84572780682E+00 -9.84673864840E+00 -9.84776673956E+00 -9.84912749087E+00 -9.85054020912E+00 -9.85219256717E+00 -9.85405527894E+00 -9.85609088855E+00 -9.85835919112E+00 -9.86082920825E+00 -9.86355935546E+00 -9.86649889300E+00 -9.86972278175E+00 -9.87319208105E+00 -9.87692942388E+00 -9.88096076239E+00 -9.88527146617E+00 -9.88990458171E+00 -9.89483875478E+00 -9.90009417439E+00 -9.90568654940E+00 -9.91163847025E+00 -9.91792164849E+00 -9.92457957292E+00 -9.93161406301E+00 -9.93902041073E+00 -9.94681893227E+00 -9.95501602123E+00 -9.96360906564E+00 -9.97261245646E+00 -9.98202405729E+00 -9.99184894135E+00 -1.00020883159E+01 -1.00127376879E+01 -1.00237975085E+01 -1.00352658578E+01 -1.00471258812E+01 -1.00593789148E+01 -1.00720044756E+01 -1.00849914622E+01 -1.00983175292E+01 -1.01119641691E+01 -1.01259022948E+01 -1.01401041413E+01 -1.01545328574E+01 -1.01691522121E+01 -1.01839197589E+01 -1.01987833893E+01 -1.02136949699E+01 -1.02285939348E+01 -1.02434184269E+01 -1.02580997824E+01 -1.02725656975E+01 -1.02867377019E+01 -1.03005326776E+01 -1.03138643351E+01 -1.03266400825E+01 -1.03387656078E+01 -1.03501416560E+01 -1.03606678322E+01 -1.03702410944E+01 -1.03787575837E+01 -1.03861138382E+01 -1.03922068861E+01 -1.03969369351E+01 -1.04002069020E+01 -1.04019255666E+01 -1.04020075939E+01 -1.04003759612E+01 -1.03969632838E+01 -1.03917128836E+01 -1.03845813766E+01 -1.03755389025E+01 -1.03645713208E+01 -1.03516811674E+01 -1.03368886060E+01 -1.03202321489E+01 -1.03017693359E+01 -1.02815766074E+01 -1.02597495131E+01 -1.02364014608E+01 -1.02116634856E+01 -1.01856823696E+01 -1.01586190513E+01 -1.01306465051E+01 -1.01019474148E+01 -1.00727114988E+01 -1.00431326444E+01 -1.00134063840E+01 -9.98372667394E+00 -9.95428357308E+00 -9.92526048750E+00 -9.89683218829E+00 -9.86916272929E+00 -9.84240405943E+00 -9.81669491571E+00 -9.79215997847E+00 -9.76890957789E+00 -9.74703956441E+00 -9.72663146547E+00 -9.70775281648E+00 -9.69045762235E+00 -9.67478673242E+00 -9.66076831694E+00 -9.64841806849E+00 -9.63773932695E+00 -9.62872295926E+00 -9.62134697980E+00 -9.61557594763E+00 -9.61136012269E+00 -9.60863441287E+00 -9.60731720340E+00 -9.60730910547E+00 -9.60849178204E+00 -9.61072692012E+00 -9.61385553218E+00 -9.61769774175E+00 -9.62205315742E+00 -9.62670204121E+00 -9.63140732978E+00 -9.63591759600E+00 -9.63997095992E+00 -9.64329986323E+00 -9.64563657159E+00 -9.64671914546E+00 -9.64629759646E+00 -9.64413984481E+00 -9.64003710300E+00 -9.63380831894E+00 -9.62530335581E+00 -9.61440468187E+00 -9.60102746243E+00 -9.58511805898E+00 -9.56665108261E+00 -9.54562524255E+00 -9.52205831845E+00 -9.49598162406E+00 -9.46743433340E+00 -9.43645801157E+00 -9.40309164139E+00 -9.36736735400E+00 -9.32930700348E+00 -9.28891964513E+00 -9.24619991057E+00 -9.20112722512E+00 -9.15366577631E+00 -9.10376512160E+00 -9.05136131844E+00 -8.99637846407E+00 -8.93873054222E+00 -8.87832349086E+00 -8.81505742326E+00 -8.74882894949E+00 -8.67953356373E+00 -8.60706807608E+00 -8.53133307596E+00 -8.45223542586E+00 -8.36969078615E+00 -8.28362617660E+00 -8.19398258040E+00 -8.10071759497E+00 -8.00380813186E+00 -7.90325316463E+00 -7.79907651836E+00 -7.69132969082E+00 -7.58009469087E+00 -7.46548687616E+00 -7.34765777250E+00 -7.22679785948E+00 -7.10313931544E+00 -6.97740615851E+00 -6.85052528303E+00 -6.72263138967E+00 -6.59375652007E+00 -6.46468546864E+00 -6.33631635548E+00 -6.20894666719E+00 -6.08283462432E+00 -5.95858619563E+00 -5.83683258226E+00 -5.71822406291E+00 -5.60342271113E+00 -5.49309399688E+00 -5.38789732656E+00 -5.28847562268E+00 -5.19544408983E+00 -5.10937838097E+00 -5.03080228529E+00 -4.96017644026E+00 -4.89787707517E+00 -4.84427146209E+00 -4.79889283392E+00 -4.76807653526E+00 -4.69321057283E+00 -4.62371906191E+00 -4.55485254714E+00 -4.48704913209E+00 -4.42025036659E+00 -4.35444556557E+00 -4.28961968500E+00 -4.22575831350E+00 -4.16284719423E+00 -4.10087227020E+00 -4.03981967924E+00 -3.97967575339E+00 -3.92042701777E+00 -3.86206018918E+00 -3.80456217460E+00 -3.74792006953E+00 -3.69212115612E+00 -3.63715290134E+00 -3.58300295490E+00 -3.52965914723E+00 -3.47710948727E+00 -3.42534216034E+00 -3.37434552587E+00 -3.32410811511E+00 -3.27461862893E+00 -3.22586593542E+00 -3.17783906769E+00 -3.13052722149E+00 -3.08391975299E+00 -3.03800617645E+00 -2.99277616194E+00 -2.94821953313E+00 -2.90432626504E+00 -2.86108648182E+00 -2.81849045456E+00 -2.77652859914E+00 -2.73519147408E+00 -2.69446977844E+00 -2.65435434972E+00 -2.61483616183E+00 -2.57590632305E+00 -2.53755607401E+00 -2.49977678576E+00 -2.46255995783E+00 -2.42589721627E+00 -2.38978031181E+00 -2.35420111801E+00 -2.31915162940E+00 -2.28462395968E+00 -2.25061034000E+00 -2.21710311713E+00 -2.18409475183E+00 -2.15157781705E+00 -2.11954499637E+00 -2.08798908227E+00 -2.05690297454E+00 -2.02627967869E+00 -1.99611230437E+00 -1.96639406382E+00 -1.93711827032E+00 -1.90827833671E+00 -1.87986777393E+00 -1.85188018950E+00 -1.82430928612E+00 -1.79714886024E+00 -1.77039280067E+00 -1.74403508721E+00 -1.71806978925E+00 -1.69249106451E+00 -1.66729315765E+00 -1.64247039904E+00 -1.61801720342E+00 -1.59392806869E+00 -1.57019757467E+00 -1.54682038185E+00 -1.52379123023E+00 -1.50110493811E+00 -1.47875640093E+00 -1.45674059012E+00 -1.43505255201E+00 -1.41368740664E+00 -1.39264034674E+00 -1.37190663658E+00 -1.35148161097E+00 -1.33136067417E+00 -1.31153929887E+00 -1.29201302515E+00 -1.27277745952E+00 -1.25382827389E+00 -1.23516120461E+00 -1.21677205152E+00 -1.19865667698E+00 -1.18081100497E+00 -1.16323102016E+00 -1.14591276698E+00 -1.12885234877E+00 -1.11204592689E+00 -1.09548971982E+00 -1.07918000239E+00 -1.06311310484E+00 -1.04728541208E+00 -1.03169336283E+00 -1.01633344883E+00 -1.00120221404E+00 -9.86296253901E-01 -9.71612214514E-01 -9.57146791926E-01 -9.42896731368E-01 -9.28858826529E-01 -9.15029918833E-01 -9.01406896727E-01 -8.87986694983E-01 -8.74766294008E-01 -8.61742719163E-01 -8.48913040096E-01 -8.36274370080E-01 -8.23823865368E-01 -8.11558724547E-01 -7.99476187912E-01 -7.87573536846E-01 -7.75848093203E-01 -7.64297218711E-01 -7.52918314376E-01 -7.41708819899E-01 -7.30666213095E-01 -7.19788009331E-01 -7.09071760967E-01 -6.98515056800E-01 -6.88115521526E-01 -6.77870815206E-01 -6.67778632736E-01 -6.57836703331E-01 -6.48042790013E-01 -6.38394689109E-01 -6.28890229754E-01 -6.19527273403E-01 -6.10303713347E-01 -6.01217474247E-01 -5.92266511657E-01 -5.83448811572E-01 -5.74762389968E-01 -5.66205292362E-01 -5.57775593370E-01 -5.49471396270E-01 -5.41290827831E-01 -5.33232057020E-01 -5.25293265700E-01 -5.17472667609E-01 -5.09768503076E-01 -5.02179038629E-01 -4.94702566604E-01 -4.87337376436E-01 -4.80081868309E-01 -4.72934380649E-01 -4.65893305239E-01 -4.58957057803E-01 -4.52124104949E-01 -4.45392853966E-01 -4.38761818255E-01 -4.32229505804E-01 -4.25794446816E-01 -4.19455193374E-01 -4.13210319121E-01 -4.07058418932E-01 -4.00998108606E-01 -3.95028024545E-01 -3.89146823457E-01 -3.83353182046E-01 -3.77645796718E-01 -3.72023383287E-01 -3.66484676688E-01 -3.61028430687E-01 -3.55653417605E-01 -3.50358428044E-01 -3.45142270606E-01 -3.40003771636E-01 -3.34941774948E-01 -3.29955141574E-01 -3.25042749498E-01 -3.20203493411E-01 -3.15436284462E-01 -3.10740050008E-01 -3.06113733376E-01 -3.01556293625E-01 -2.97066705312E-01 -2.92643958262E-01 -2.88287057343E-01 -2.83995022221E-01 -2.79766887178E-01 -2.75601700865E-01 -2.71498526097E-01 -2.67456439643E-01 -2.63474532016E-01 -2.59551907271E-01 -2.55687682799E-01 -2.51880989135E-01 -2.48130969756E-01 -2.44436780892E-01 -2.40797591335E-01 -2.37212582252E-01 -2.33680947000E-01 -2.30201890948E-01 -2.26774631292E-01 -2.23398396885E-01 -2.20072428060E-01 -2.16795976459E-01 -2.13568304868E-01 -2.10388687046E-01 -2.07256407566E-01 -2.04170761653E-01 -2.01131055022E-01 -1.98136603727E-01 -1.95186734004E-01 -1.92280782120E-01 -1.89418094223E-01 -1.86598026196E-01 -1.83819943512E-01 -1.81083221091E-01 -1.78387243158E-01 -1.75731403108E-01 -1.73115103365E-01 -1.70537755250E-01 -1.67998778850E-01 -1.65497602884E-01 -1.63033664577E-01 -1.60606409532E-01 -1.58215291607E-01 -1.55859772790E-01 -1.53539323079E-01 -1.51253420364E-01 -1.49001550306E-01 -1.46783206226E-01 -1.44597888986E-01 -1.42445106882E-01 -1.40324375527E-01 -1.38235217749E-01 -1.36177163479E-01 -1.34149749644E-01 -1.32152520069E-01 -1.30185025369E-01 -1.28246822848E-01 -1.26337476404E-01 -1.24456556425E-01 -1.22603639696E-01 -1.20778309304E-01 -1.18980154540E-01 -1.17208770813E-01 -1.15463759554E-01 -1.13744728128E-01 -1.12051289746E-01 -1.10383063377E-01 -1.08739673663E-01 -1.07120750834E-01 -1.05525930625E-01 -1.03954854197E-01 -1.02407168049E-01 -1.00882523946E-01 -9.93805788366E-02 -9.79009947766E-02 -9.64434388535E-02 -9.50075831109E-02 -9.35931044754E-02 -9.21996846833E-02 -9.08270102091E-02 -8.94747721955E-02 -8.81426663830E-02 -8.68303930424E-02 -8.55376569065E-02 -8.42641671043E-02 -8.30096370951E-02 -8.17737846045E-02 -8.05563315605E-02 1 0 Beta L 361 3.10523138144E+00 3.15215180909E+00 3.19978092773E+00 3.24812942851E+00 3.29720816325E+00 3.34702814686E+00 3.39760055972E+00 3.44893675017E+00 3.50104823701E+00 3.55394671197E+00 3.60764404236E+00 3.66215227357E+00 3.71748363180E+00 3.77365052666E+00 3.83066555393E+00 3.88869360655E+00 3.94644640843E+00 4.00785861767E+00 4.06786819131E+00 4.12607719707E+00 4.19237547204E+00 4.25267611670E+00 4.31897676089E+00 4.38336552998E+00 4.45035533791E+00 4.51548698304E+00 4.58719175105E+00 4.65334185791E+00 4.72502999457E+00 4.79586813055E+00 4.86870436260E+00 4.94205880281E+00 5.01708557641E+00 5.09157119161E+00 5.17053112711E+00 5.24636375061E+00 5.33083225725E+00 5.40161860722E+00 5.49311529457E+00 5.56852848228E+00 5.65665284604E+00 5.73838119387E+00 5.83395047139E+00 5.90844856701E+00 6.01503391719E+00 6.08834727078E+00 6.18959492470E+00 6.28647779337E+00 6.37047862774E+00 6.47037772724E+00 6.57509503886E+00 6.66863495603E+00 6.76847622736E+00 6.87399349171E+00 6.97271765839E+00 7.08319740726E+00 7.18820118478E+00 7.29805424436E+00 7.40351624598E+00 7.51956402049E+00 7.63176550728E+00 7.74871475979E+00 7.86139611447E+00 7.98376176198E+00 8.10191076553E+00 8.22650128639E+00 8.34811227554E+00 8.47567791519E+00 8.60239398239E+00 8.73257500816E+00 8.86423451779E+00 8.99860673237E+00 9.13333946341E+00 9.27163437269E+00 9.41103142399E+00 9.55253196164E+00 9.69751705590E+00 9.84276194524E+00 9.99154684468E+00 1.01419203236E+01 1.02949925946E+01 1.04498814715E+01 1.06073694137E+01 1.07669114474E+01 1.09295640595E+01 1.10937050938E+01 1.12611145575E+01 1.14301198965E+01 1.16030632400E+01 1.17769033527E+01 1.19545430902E+01 1.21344710760E+01 1.23168176393E+01 1.25024485320E+01 1.26902836175E+01 1.28813235119E+01 1.30748674795E+01 1.32716622906E+01 1.34710094441E+01 1.36736691880E+01 1.38789925473E+01 1.40877652362E+01 1.42992503195E+01 1.45140732315E+01 1.47321587253E+01 1.49533099999E+01 1.51774518143E+01 1.54085196749E+01 1.56333262381E+01 1.58719743286E+01 1.61107073030E+01 1.63503980163E+01 1.65934310064E+01 1.68482339868E+01 1.70962686689E+01 1.73535456242E+01 1.76152701116E+01 1.78756888411E+01 1.81413639736E+01 1.84233645091E+01 1.86855538882E+01 1.89747672371E+01 1.92529512320E+01 1.95454121458E+01 1.98321413376E+01 2.01322044518E+01 2.04313701326E+01 2.07371220759E+01 2.10440703907E+01 2.13609787377E+01 2.16772261217E+01 2.20017185061E+01 2.23289506445E+01 2.26612406516E+01 2.29975250513E+01 2.33409398991E+01 2.36867801959E+01 2.40393658831E+01 2.43966550459E+01 2.47581424130E+01 2.51256372420E+01 2.54984557766E+01 2.58752100048E+01 2.62593572348E+01 2.66479301642E+01 2.70414191337E+01 2.74410223890E+01 2.78469193746E+01 2.82574255440E+01 2.86740623019E+01 2.90969943386E+01 2.95250560399E+01 2.99592652201E+01 3.04000207625E+01 3.08463291048E+01 3.12991268922E+01 3.17576958140E+01 3.22230551560E+01 3.26943849739E+01 3.31723870908E+01 3.36567166653E+01 3.41476482202E+01 3.46452877189E+01 3.51491902945E+01 3.56605468765E+01 3.61778811355E+01 3.67027135102E+01 3.72341886833E+01 3.77725540813E+01 3.83181168114E+01 3.88706587962E+01 3.94304560812E+01 3.99972894533E+01 4.05715516736E+01 4.11529195297E+01 4.17417238581E+01 4.23379399361E+01 4.29415151869E+01 4.35526443446E+01 4.41711621451E+01 4.47973029744E+01 4.54310383205E+01 4.60723615458E+01 4.67212136166E+01 4.73778704656E+01 4.80421219228E+01 4.87140282040E+01 4.93936915698E+01 5.00810280338E+01 5.07760418736E+01 5.14787912129E+01 5.21891963047E+01 5.29072851130E+01 5.36330166678E+01 5.43663581840E+01 5.51073048704E+01 5.58557877610E+01 5.66117334562E+01 5.73751637819E+01 5.81459197502E+01 5.89239938358E+01 5.97092632633E+01 6.05016658624E+01 6.13010633560E+01 6.21073683659E+01 6.29204348008E+01 6.37401493299E+01 6.45663397072E+01 6.53988348612E+01 6.62374993132E+01 6.70820947297E+01 6.79324419676E+01 6.87883079295E+01 6.96494610372E+01 7.05156367889E+01 7.13865659852E+01 7.22619594780E+01 7.31414929398E+01 7.40248452537E+01 7.49116508280E+01 7.58015417457E+01 7.66941087282E+01 7.75889294684E+01 7.84855536819E+01 7.93834996075E+01 8.02822662010E+01 8.11813125270E+01 8.20800792924E+01 8.29779645337E+01 8.38743426541E+01 8.47685486491E+01 8.56598819390E+01 8.65476107965E+01 8.74309560700E+01 8.83091074266E+01 8.91812096748E+01 9.00463640585E+01 9.09036286835E+01 9.17520164028E+01 9.25904907146E+01 9.34179687889E+01 9.42333117949E+01 9.50353354148E+01 9.58227951438E+01 9.65943928505E+01 9.73487725272E+01 9.80845186522E+01 9.88001539148E+01 9.94941376779E+01 1.00164866681E+02 1.00810667503E+02 1.01429802164E+02 1.02020459839E+02 1.02580760795E+02 1.03108749916E+02 1.03602398972E+02 1.04059604177E+02 1.04478182971E+02 1.04855875900E+02 1.05190343382E+02 1.05479165613E+02 1.05719842084E+02 1.05909790604E+02 1.06046347055E+02 1.06126766377E+02 1.06148221248E+02 1.06107804153E+02 1.06002527524E+02 1.05829325441E+02 1.05585055596E+02 1.05266501644E+02 1.04870375996E+02 1.04393323349E+02 1.03831924978E+02 1.03182704089E+02 1.02442130570E+02 1.01606628980E+02 1.00672585133E+02 9.96363553757E+01 9.84942764093E+01 9.72426760076E+01 9.58778863371E+01 9.43962570966E+01 9.27941715258E+01 9.10680639282E+01 8.92144385807E+01 8.72298910885E+01 8.51111318424E+01 8.28550115265E+01 8.04585497143E+01 7.79189654545E+01 7.52337110687E+01 7.24005087350E+01 6.94173904912E+01 6.62827415291E+01 6.29953464428E+01 5.95544399555E+01 5.59597611236E+01 5.22116111278E+01 4.83109155302E+01 4.42592904763E+01 4.00591130953E+01 3.57135956502E+01 3.12268643835E+01 2.66040415112E+01 2.18513315842E+01 1.69761101797E+01 1.19870165315E+01 6.89404752647E+00 1.70865304235E+00 -3.55616743440E+00 -8.88577007131E+00 -1.42637735514E+01 -1.96719704269E+01 -2.50902441577E+01 -3.04964954407E+01 -3.58665791900E+01 -4.11742571030E+01 -4.63911680136E+01 -5.14868214670E+01 -5.64286183567E+01 -6.11819044255E+01 -6.57100618641E+01 -6.99746454841E+01 -7.39355698578E+01 -7.75513538748E+01 -8.07794301750E+01 -8.35765257943E+01 -8.58991208695E+01 -8.77039908767E+01 -8.89488378604E+01 -8.95930133101E+01 -8.95983348857E+01 -8.89299948892E+01 -8.75575566851E+01 -8.54560303628E+01 -8.26070141890E+01 -7.89998838075E+01 -7.46330041151E+01 -6.95149327956E+01 -6.36655776751E+01 -5.71172627011E+01 -4.99156512287E+01 -4.21204696028E+01 -3.38059664269E+01 -2.50610690802E+01 -1.59889190580E+01 -6.70818156317E+00 2.66771711996E+00 1.18432071604E+01 2.21737346723E+01 1.89495443314E+01 1.49888746709E+01 8.91860804799E+00 -8.83318545469E-01 8.74945810989E-02 -8.66649655173E-03 8.58425982743E-04 -8.50245520003E-05 8.41671286040E-06 -8.39950440491E-07 2 0 Beta L 361 5.00346092155E+00 5.07906384494E+00 5.15580868336E+00 5.23371266350E+00 5.31279327096E+00 5.39306825410E+00 5.47455562793E+00 5.55727367809E+00 5.64124096488E+00 5.72647632726E+00 5.81299888706E+00 5.90082805313E+00 5.98998352558E+00 6.08048530011E+00 6.17235367237E+00 6.26584875592E+00 6.35895693170E+00 6.45781983169E+00 6.55454050560E+00 6.64849847169E+00 6.75512475608E+00 6.85244182418E+00 6.95916885060E+00 7.06296250541E+00 7.17086477005E+00 7.27591886422E+00 7.39128035126E+00 7.49802794240E+00 7.61346950592E+00 7.72763921173E+00 7.84498138873E+00 7.96318780695E+00 8.08406038291E+00 8.20414614429E+00 8.33127119670E+00 8.45357630977E+00 8.58941539369E+00 8.70396868634E+00 8.85089617073E+00 8.97279342606E+00 9.11458638733E+00 9.24646536164E+00 9.40000453786E+00 9.52073566808E+00 9.69159679823E+00 9.81061631580E+00 9.97328846199E+00 1.01292218709E+01 1.02651287799E+01 1.04259131503E+01 1.05942890737E+01 1.07453014715E+01 1.09062217422E+01 1.10760751240E+01 1.12354088958E+01 1.14131635813E+01 1.15824557895E+01 1.17593961842E+01 1.19295694163E+01 1.21163432125E+01 1.22972022246E+01 1.24855562940E+01 1.26673401107E+01 1.28643234556E+01 1.30548194237E+01 1.32554581947E+01 1.34515425100E+01 1.36570127751E+01 1.38612545861E+01 1.40710006973E+01 1.42831536619E+01 1.44996402432E+01 1.47167922579E+01 1.49396063870E+01 1.51642461862E+01 1.53922752530E+01 1.56258503169E+01 1.58599413802E+01 1.60996680751E+01 1.63419874142E+01 1.65886331427E+01 1.68382307718E+01 1.70920027025E+01 1.73491005236E+01 1.76111743973E+01 1.78756950340E+01 1.81454416706E+01 1.84178066538E+01 1.86964459493E+01 1.89766166471E+01 1.92628496192E+01 1.95527889372E+01 1.98466398730E+01 2.01457552836E+01 2.04484519034E+01 2.07562930048E+01 2.10681874627E+01 2.13853026276E+01 2.17065506600E+01 2.20331200670E+01 2.23640005421E+01 2.27004202562E+01 2.30412315994E+01 2.33874129678E+01 2.37388491239E+01 2.40952354288E+01 2.44564570006E+01 2.48286566108E+01 2.51912612051E+01 2.55756388085E+01 2.59603281168E+01 2.63466935550E+01 2.67384582962E+01 2.71487744603E+01 2.75487200985E+01 2.79632786404E+01 2.83849718543E+01 2.88048257567E+01 2.92330820324E+01 2.96870143375E+01 3.01102421243E+01 3.05758448067E+01 3.10244509485E+01 3.14955488744E+01 3.19579221421E+01 3.24413220702E+01 3.29235464513E+01 3.34162753474E+01 3.39111020632E+01 3.44217039335E+01 3.49315120072E+01 3.54544258220E+01 3.59818587759E+01 3.65174312055E+01 3.70594871678E+01 3.76129234834E+01 3.81704021585E+01 3.87386674022E+01 3.93145366110E+01 3.98972249946E+01 4.04895592716E+01 4.10904763346E+01 4.16978138166E+01 4.23169704153E+01 4.29433196127E+01 4.35776304236E+01 4.42217763890E+01 4.48760414420E+01 4.55378008028E+01 4.62094324779E+01 4.68911974688E+01 4.75812808263E+01 4.82812748542E+01 4.89918060272E+01 4.97113279781E+01 5.04413064574E+01 5.11806246313E+01 5.19308772705E+01 5.26907889447E+01 5.34614591250E+01 5.42423537966E+01 5.50339056277E+01 5.58362841524E+01 5.66487993819E+01 5.74733141194E+01 5.83075286153E+01 5.91538199870E+01 6.00108576177E+01 6.08790318578E+01 6.17588263579E+01 6.26499048896E+01 6.35527025486E+01 6.44668814091E+01 6.53930586552E+01 6.63307339653E+01 6.72804278581E+01 6.82421058639E+01 6.92156899267E+01 7.02014880860E+01 7.11992463053E+01 7.22093343913E+01 7.32317116854E+01 7.42663716109E+01 7.53132257626E+01 7.63727084758E+01 7.74444952654E+01 7.85286835718E+01 7.96254364077E+01 8.07346258765E+01 8.18562618347E+01 8.29904379923E+01 8.41370327131E+01 8.52960923508E+01 8.64675555472E+01 8.76513734248E+01 8.88475407600E+01 9.00559518119E+01 9.12764938226E+01 9.25092024098E+01 9.37538306514E+01 9.50103678752E+01 9.62786231540E+01 9.75584999487E+01 9.88497825241E+01 1.00152334313E+02 1.01465926742E+02 1.02790381983E+02 1.04125429845E+02 1.05470801533E+02 1.06826283438E+02 1.08191500810E+02 1.09566170878E+02 1.10949926074E+02 1.12342400679E+02 1.13743176932E+02 1.15151829153E+02 1.16567899864E+02 1.17990875937E+02 1.19420248560E+02 1.20855438687E+02 1.22295862863E+02 1.23740872123E+02 1.25189796354E+02 1.26641920763E+02 1.28096480395E+02 1.29552679171E+02 1.31009657600E+02 1.32466526380E+02 1.33922328330E+02 1.35376068147E+02 1.36826687573E+02 1.38273071425E+02 1.39714054401E+02 1.41148395565E+02 1.42574803683E+02 1.43991915754E+02 1.45398298926E+02 1.46792451137E+02 1.48172797663E+02 1.49537684651E+02 1.50885383766E+02 1.52214076915E+02 1.53521872650E+02 1.54806783044E+02 1.56066733848E+02 1.57299557738E+02 1.58502991630E+02 1.59674673022E+02 1.60812137443E+02 1.61912819449E+02 1.62974040706E+02 1.63993018598E+02 1.64966853146E+02 1.65892533044E+02 1.66766925370E+02 1.67586778981E+02 1.68348720609E+02 1.69049249599E+02 1.69684740762E+02 1.70251439153E+02 1.70745459769E+02 1.71162786665E+02 1.71499271252E+02 1.71750631814E+02 1.71912454875E+02 1.71980193027E+02 1.71949168029E+02 1.71814570903E+02 1.71571464503E+02 1.71214786483E+02 1.70739352901E+02 1.70139862522E+02 1.69410902281E+02 1.68546953990E+02 1.67542402719E+02 1.66391544233E+02 1.65088597595E+02 1.63627715521E+02 1.62002999076E+02 1.60208513211E+02 1.58238303764E+02 1.56086418634E+02 1.53746928659E+02 1.51213953124E+02 1.48481687688E+02 1.45544434571E+02 1.42396636653E+02 1.39032914990E+02 1.35448109624E+02 1.31637325380E+02 1.27595980884E+02 1.23319862770E+02 1.18805184393E+02 1.14048650072E+02 1.09047524664E+02 1.03799707931E+02 9.83038161562E+01 9.25592694017E+01 8.65663846017E+01 8.03264758976E+01 7.38419613919E+01 6.71164767369E+01 6.01549948388E+01 5.29639532099E+01 4.55513864892E+01 3.79270660970E+01 3.01026437575E+01 2.20918014841E+01 1.39104038997E+01 5.57665285370E+00 -2.88875574722E+00 -1.14624779791E+01 -2.01183703498E+01 -2.88273453065E+01 -3.75572357190E+01 -4.62726741389E+01 -5.49349890216E+01 -6.35021258582E+01 -7.19285967628E+01 -8.01654672723E+01 -8.81603865514E+01 -9.58576703588E+01 -1.03198445224E+02 -1.10120864285E+02 -1.16560405116E+02 -1.22450259971E+02 -1.27721830506E+02 -1.32305337232E+02 -1.36130554813E+02 -1.39127682076E+02 -1.41228355641E+02 -1.42366811526E+02 -1.42481198399E+02 -1.41515039220E+02 -1.39418835268E+02 -1.36151798689E+02 -1.31683692045E+02 -1.25996745933E+02 -1.19087614453E+02 -1.10969318690E+02 -1.01673117382E+02 -9.12502320728E+01 -7.97733441408E+01 -6.73377719056E+01 -5.40622237170E+01 -4.00890647967E+01 -2.55835870164E+01 -1.07361179802E+01 4.27123025772E+00 1.89643962937E+01 3.55138475496E+01 3.03555846091E+01 2.40150207471E+01 1.42916959304E+01 -1.41570991376E+00 1.40251007999E-01 -1.38942152471E-02 1.37643805067E-03 -1.36351296342E-04 1.34994456804E-05 -1.34738464398E-06 3 1 Beta L 365 1.09270667529E-02 1.12598162499E-02 1.16026976703E-02 1.19560194654E-02 1.23170500421E-02 1.26924485239E-02 1.30789482704E-02 1.34772368911E-02 1.38877316898E-02 1.43099406957E-02 1.47524488993E-02 1.51779679498E-02 1.56931993302E-02 1.61191561272E-02 1.66079510702E-02 1.71376585492E-02 1.76518415868E-02 1.82032919561E-02 1.87532824110E-02 1.92982469523E-02 1.99181927418E-02 2.04995496265E-02 2.11410052593E-02 2.17774197958E-02 2.24471804254E-02 2.31122432800E-02 2.38471199689E-02 2.45447624747E-02 2.53049327302E-02 2.60703915353E-02 2.68678840721E-02 2.76841561574E-02 2.85307155449E-02 2.93865419852E-02 3.03019199965E-02 3.12013934361E-02 3.22055385233E-02 3.30837038654E-02 3.41968791526E-02 3.51561319473E-02 3.62707768244E-02 3.73336609378E-02 3.85713413461E-02 3.95889417274E-02 4.09971241170E-02 4.20373057080E-02 4.34292022881E-02 4.47931598922E-02 4.60210525077E-02 4.74688911530E-02 4.90036236408E-02 5.04208995328E-02 5.19447551815E-02 5.35704996602E-02 5.51323932289E-02 5.68826383823E-02 5.85871713718E-02 6.03894124098E-02 6.21597887309E-02 6.41146959271E-02 6.60468120645E-02 6.80836907200E-02 7.00904287691E-02 7.22814642439E-02 7.44444985394E-02 7.67473497754E-02 7.90420277990E-02 8.14737544724E-02 8.39336325075E-02 8.64944033710E-02 8.91249500329E-02 9.18482798568E-02 9.46251298487E-02 9.75137705779E-02 1.00472588991E-01 1.03521301105E-01 1.06688339998E-01 1.09915079137E-01 1.13266044292E-01 1.16706188502E-01 1.20259867197E-01 1.23911433233E-01 1.27679926522E-01 1.31556202846E-01 1.35565470162E-01 1.39676214907E-01 1.43929253774E-01 1.48291270223E-01 1.52817390074E-01 1.57442238423E-01 1.62235186949E-01 1.67164930416E-01 1.72237764773E-01 1.77477917030E-01 1.82863149262E-01 1.88421621237E-01 1.94139837693E-01 2.00040655551E-01 2.06110457241E-01 2.12373229296E-01 2.18816183084E-01 2.25464946860E-01 2.32304349288E-01 2.39356009048E-01 2.46623141354E-01 2.54105589314E-01 2.61805302969E-01 2.69846265912E-01 2.77836365517E-01 2.86390577070E-01 2.95096866775E-01 3.03984482267E-01 3.13133233860E-01 3.22826250031E-01 3.32463455475E-01 3.42578604859E-01 3.53022191094E-01 3.63601724874E-01 3.74549085098E-01 3.86272105781E-01 3.97479870538E-01 4.09876763629E-01 4.22078244353E-01 4.35033505315E-01 4.47993553808E-01 4.61700261942E-01 4.75610529702E-01 4.90028654537E-01 5.04746449589E-01 5.20134102385E-01 5.35763106280E-01 5.52016685829E-01 5.68673400335E-01 5.85843348430E-01 6.03491538872E-01 6.21772056094E-01 6.40483667107E-01 6.59837575817E-01 6.79753882788E-01 7.00220509011E-01 7.21339482608E-01 7.43092270000E-01 7.65424596431E-01 7.88526144937E-01 8.12263106124E-01 8.36675134508E-01 8.61842644305E-01 8.87793724099E-01 9.14454984997E-01 9.41927701256E-01 9.70240930665E-01 9.99348141139E-01 1.02932721378E+00 1.06022328038E+00 1.09199863547E+00 1.12473150505E+00 1.15840036329E+00 1.19309179953E+00 1.22877845485E+00 1.26552933462E+00 1.30334788507E+00 1.34227771241E+00 1.38235339290E+00 1.42357139282E+00 1.46604277409E+00 1.50969336178E+00 1.55466045968E+00 1.60091420531E+00 1.64850358772E+00 1.69748404410E+00 1.74787283948E+00 1.79972541899E+00 1.85306009143E+00 1.90794408962E+00 1.96438896852E+00 2.02245980699E+00 2.08219410168E+00 2.14362795696E+00 2.20681942877E+00 2.27179702839E+00 2.33862500215E+00 2.40734605204E+00 2.47800590880E+00 2.55064648390E+00 2.62534212582E+00 2.70212340068E+00 2.78104720715E+00 2.86217618712E+00 2.94555639131E+00 3.03124357109E+00 3.11930062463E+00 3.20977787801E+00 3.30273808814E+00 3.39823831577E+00 3.49633813401E+00 3.59710149182E+00 3.70058715481E+00 3.80685447875E+00 3.91597551987E+00 4.02800321145E+00 4.14300942729E+00 4.26105438975E+00 4.38220692690E+00 4.50652845055E+00 4.63408815698E+00 4.76494955455E+00 4.89918200966E+00 5.03684895129E+00 5.17801548188E+00 5.32275306486E+00 5.47112112765E+00 5.62318851701E+00 5.77901835783E+00 5.93867545927E+00 6.10222154934E+00 6.26971909546E+00 6.44122917864E+00 6.61680901263E+00 6.79651769575E+00 6.98040886429E+00 7.16853695757E+00 7.36095139144E+00 7.55770026146E+00 7.75882839670E+00 7.96437645581E+00 8.17438264555E+00 8.38887931138E+00 8.60789621953E+00 8.83145640235E+00 9.05957895587E+00 9.29227640419E+00 9.52955486077E+00 9.77141471117E+00 1.00178473120E+01 1.02688376813E+01 1.05243617114E+01 1.07843861190E+01 1.10488679808E+01 1.13177542238E+01 1.15909802342E+01 1.18684700747E+01 1.21501342567E+01 1.24358712731E+01 1.27255641253E+01 1.30190812197E+01 1.33162749410E+01 1.36169807434E+01 1.39210160488E+01 1.42281793785E+01 1.45382498035E+01 1.48509845793E+01 1.51661198261E+01 1.54833678690E+01 1.58024172954E+01 1.61229307613E+01 1.64445448090E+01 1.67668681474E+01 1.70894803020E+01 1.74119310561E+01 1.77337386701E+01 1.80543889404E+01 1.83733340479E+01 1.86899914118E+01 1.90037423079E+01 1.93139312888E+01 1.96198645148E+01 1.99208093066E+01 2.02159929365E+01 2.05046018426E+01 2.07857809646E+01 2.10586330668E+01 2.13222182320E+01 2.15755535876E+01 2.18176130542E+01 2.20473274662E+01 2.22635846832E+01 2.24652301471E+01 2.26510676901E+01 2.28198603787E+01 2.29703321215E+01 2.31011692347E+01 2.32110226096E+01 2.32985103391E+01 2.33622206657E+01 2.34007155949E+01 2.34125349328E+01 2.33962010676E+01 2.33502242632E+01 2.32731087009E+01 2.31633593272E+01 2.30194893656E+01 2.28400287748E+01 2.26235335713E+01 2.23685960719E+01 2.20738561657E+01 2.17380135893E+01 2.13598413016E+01 2.09382000023E+01 2.04720537426E+01 1.99604867774E+01 1.94027215953E+01 1.87981381296E+01 1.81462942118E+01 1.74469471508E+01 1.67000764725E+01 1.59059077052E+01 1.50649371380E+01 1.41779574148E+01 1.32460838007E+01 1.22707809094E+01 1.12538896565E+01 1.01976540804E+01 9.10474769275E+00 7.97829890274E+00 6.82191492136E+00 5.63970366766E+00 4.43629278649E+00 3.21684509385E+00 1.98706944641E+00 7.53226012693E-01 -4.77875241941E-01 -1.69888412804E+00 -2.90192929707E+00 -4.07864830675E+00 -5.22023029508E+00 -6.31747294454E+00 -7.36085549794E+00 -8.34062943769E+00 -9.24692858114E+00 -1.00698999603E+01 -1.07998567830E+01 -1.14274543276E+01 -1.19438891111E+01 -1.23411210357E+01 -1.26121173791E+01 -1.27511164169E+01 -1.27539072539E+01 -1.26181209847E+01 -1.23435266364E+01 -1.19323234881E+01 -1.13894194645E+01 -1.07226831373E+01 -9.94315492296E+00 -9.06520103529E+00 -8.10659214648E+00 -7.08848728587E+00 -6.03530288612E+00 -4.97444676026E+00 -3.93589768716E+00 -2.95161379908E+00 -2.05475086763E+00 -1.27871960515E+00 -6.55769362040E-01 -2.17393407835E-01 1.85796865469E-02 -1.54118130643E-03 1.21875356763E-04 -8.90633908136E-06 5.56602593279E-07 -2.14345394302E-08 -9.56745583020E-10 9.38596013447E-10 -2.47041518250E-10 -4.69080150599E-10 -2.17524454790E-10 4 1 Beta L 365 -1.58158618711E-02 -1.62974775529E-02 -1.67937575845E-02 -1.73051483745E-02 -1.78281246606E-02 -1.83714476788E-02 -1.89308834941E-02 -1.95073788134E-02 -2.01015399266E-02 -2.07126834021E-02 -2.13529495948E-02 -2.19696802692E-02 -2.27136131248E-02 -2.33319298548E-02 -2.40395168698E-02 -2.48054162940E-02 -2.55499245908E-02 -2.63476293714E-02 -2.71438421122E-02 -2.79335440993E-02 -2.88297686261E-02 -2.96721072046E-02 -3.05999833891E-02 -3.15214016280E-02 -3.24906072248E-02 -3.34538800865E-02 -3.45164964541E-02 -3.55272630257E-02 -3.66271262964E-02 -3.77352527108E-02 -3.88894471990E-02 -4.00710123964E-02 -4.12962284611E-02 -4.25354304177E-02 -4.38596743639E-02 -4.51624030948E-02 -4.66139674622E-02 -4.78885831125E-02 -4.94962097573E-02 -5.08874782630E-02 -5.24993557603E-02 -5.40392526384E-02 -5.58272380591E-02 -5.73055454655E-02 -5.93368318912E-02 -6.08495609829E-02 -6.28604418236E-02 -6.48332380268E-02 -6.66151812720E-02 -6.87093252271E-02 -7.09276517851E-02 -7.29816120950E-02 -7.51877430510E-02 -7.75393849816E-02 -7.98024962337E-02 -8.23334650418E-02 -8.48016076447E-02 -8.74095778260E-02 -8.99744758113E-02 -9.28019788596E-02 -9.55992780600E-02 -9.85466812259E-02 -1.01453582353E-01 -1.04623042292E-01 -1.07755226750E-01 -1.11087233577E-01 -1.14410124288E-01 -1.17929047949E-01 -1.21490335293E-01 -1.25196729201E-01 -1.29004437365E-01 -1.32945984530E-01 -1.36966030787E-01 -1.41146931263E-01 -1.45430048773E-01 -1.49843266552E-01 -1.54426916692E-01 -1.59098218928E-01 -1.63948448493E-01 -1.68928199924E-01 -1.74072022382E-01 -1.79357820337E-01 -1.84812748872E-01 -1.90423883988E-01 -1.96227022255E-01 -2.02177761477E-01 -2.08333864567E-01 -2.14648435223E-01 -2.21199472252E-01 -2.27894741779E-01 -2.34832420823E-01 -2.41968413512E-01 -2.49311783692E-01 -2.56896889501E-01 -2.64692513504E-01 -2.72738580881E-01 -2.81016208112E-01 -2.89557859148E-01 -2.98344488842E-01 -3.07410173981E-01 -3.16737036153E-01 -3.26361472239E-01 -3.36262298516E-01 -3.46470206686E-01 -3.56989980467E-01 -3.67821723404E-01 -3.78968232501E-01 -3.90605071307E-01 -4.02178458961E-01 -4.14557469309E-01 -4.27160257412E-01 -4.40028416279E-01 -4.53274992211E-01 -4.67300274097E-01 -4.81256731276E-01 -4.95898800294E-01 -5.11015569939E-01 -5.26335392178E-01 -5.42186216770E-01 -5.59144577617E-01 -5.75386967063E-01 -5.93321811066E-01 -6.10993301419E-01 -6.29742899856E-01 -6.48512789129E-01 -6.68351578764E-01 -6.88492253063E-01 -7.09365330172E-01 -7.30676990123E-01 -7.52950742023E-01 -7.75581743382E-01 -7.99111770659E-01 -8.23228586441E-01 -8.48088165779E-01 -8.73641651573E-01 -9.00107362150E-01 -9.27201413642E-01 -9.55222846705E-01 -9.84059448796E-01 -1.01369462526E+00 -1.04427333393E+00 -1.07576988465E+00 -1.10810837074E+00 -1.14155743688E+00 -1.17592878829E+00 -1.21127911246E+00 -1.24772287667E+00 -1.28530046123E+00 -1.32390902391E+00 -1.36369249011E+00 -1.40469272393E+00 -1.44684487978E+00 -1.49025989131E+00 -1.53500248641E+00 -1.58102027808E+00 -1.62842483861E+00 -1.67718670773E+00 -1.72742931426E+00 -1.77911505355E+00 -1.83234251506E+00 -1.88711772745E+00 -1.94350341780E+00 -2.00154971904E+00 -2.06125275804E+00 -2.12277084943E+00 -2.18600038221E+00 -2.25113676704E+00 -2.31813917595E+00 -2.38707820557E+00 -2.45803369483E+00 -2.53103149854E+00 -2.60615151966E+00 -2.68342118742E+00 -2.76293715002E+00 -2.84471735764E+00 -2.92885553516E+00 -3.01540640194E+00 -3.10442276198E+00 -3.19598853904E+00 -3.29014588878E+00 -3.38698758735E+00 -3.48657596124E+00 -3.58897768735E+00 -3.69425409766E+00 -3.80251243895E+00 -3.91379810663E+00 -4.02819378186E+00 -4.14579033219E+00 -4.26665520740E+00 -4.39086964529E+00 -4.51852504488E+00 -4.64969508733E+00 -4.78447108306E+00 -4.92293636158E+00 -5.06517785316E+00 -5.21128875246E+00 -5.36135497385E+00 -5.51546332042E+00 -5.67371864391E+00 -5.83619878481E+00 -6.00300844523E+00 -6.17423591043E+00 -6.34998169259E+00 -6.53033586816E+00 -6.71539959061E+00 -6.90526601835E+00 -7.10003665178E+00 -7.29980464406E+00 -7.50466555737E+00 -7.71472401712E+00 -7.93006764443E+00 -8.15079743607E+00 -8.37700632554E+00 -8.60878966614E+00 -8.84623846321E+00 -9.08944479364E+00 -9.33849879652E+00 -9.59348511625E+00 -9.85449108359E+00 -1.01215962746E+01 -1.03948813781E+01 -1.06744199450E+01 -1.09602836002E+01 -1.12525392921E+01 -1.15512479829E+01 -1.18564670711E+01 -1.21682455549E+01 -1.24866286381E+01 -1.28116518429E+01 -1.31433449511E+01 -1.34817282184E+01 -1.38268126071E+01 -1.41786007086E+01 -1.45370820258E+01 -1.49022367602E+01 -1.52740318249E+01 -1.56524207212E+01 -1.60373428412E+01 -1.64287227006E+01 -1.68264679012E+01 -1.72304693993E+01 -1.76405982620E+01 -1.80567078021E+01 -1.84786285569E+01 -1.89061694966E+01 -1.93391159190E+01 -1.97772280605E+01 -2.02202394560E+01 -2.06678555906E+01 -2.11197530209E+01 -2.15755759005E+01 -2.20349368220E+01 -2.24974129145E+01 -2.29625457844E+01 -2.34298382517E+01 -2.38987539394E+01 -2.43687146678E+01 -2.48390983510E+01 -2.53092380387E+01 -2.57784191773E+01 -2.62458780750E+01 -2.67108000545E+01 -2.71723176029E+01 -2.76295081663E+01 -2.80813930995E+01 -2.85269350239E+01 -2.89650369530E+01 -2.93945402884E+01 -2.98142234417E+01 -3.02228006031E+01 -3.06189204992E+01 -3.10011653822E+01 -3.13680503551E+01 -3.17180227283E+01 -3.20494619072E+01 -3.23606792772E+01 -3.26499187281E+01 -3.29153575635E+01 -3.31551074600E+01 -3.33672165614E+01 -3.35496715256E+01 -3.37004004733E+01 -3.38172766402E+01 -3.38981225289E+01 -3.39407150808E+01 -3.39427915200E+01 -3.39020563417E+01 -3.38161891284E+01 -3.36828535336E+01 -3.34997075516E+01 -3.32644148561E+01 -3.29746576564E+01 -3.26281509507E+01 -3.22226582881E+01 -3.17560092048E+01 -3.12261183264E+01 -3.06310062866E+01 -2.99688225588E+01 -2.92378701305E+01 -2.84366322777E+01 -2.75638013473E+01 -2.66183095905E+01 -2.55993621420E+01 -2.45064719937E+01 -2.33394970363E+01 -2.20986789964E+01 -2.07846841817E+01 -1.93986458262E+01 -1.79422077904E+01 -1.64175692901E+01 -1.48275302891E+01 -1.31755369824E+01 -1.14657268273E+01 -9.70297239111E+00 -7.89292303472E+00 -6.04204365115E+00 -4.15764899037E+00 -2.24793242137E+00 -3.21987464319E-01 1.61017963123E+00 3.53764826225E+00 5.44859495552E+00 7.33032039630E+00 9.16929457496E+00 1.09512228049E+01 1.26611355045E+01 1.42835047807E+01 1.58023906220E+01 1.72016197566E+01 1.84649996053E+01 1.95765696563E+01 2.05208918530E+01 2.12833807500E+01 2.18506731300E+01 2.22110353846E+01 2.23548051574E+01 2.22748617256E+01 2.19671171490E+01 2.14310174195E+01 2.06700397221E+01 1.96921687167E+01 1.85103311174E+01 1.71427645543E+01 1.56132932787E+01 1.39514805488E+01 1.21926251196E+01 1.03775681669E+01 8.55227673658E+00 6.76717123149E+00 5.07616869003E+00 3.53540933129E+00 2.20171956050E+00 1.13025199214E+00 3.75389620500E-01 -3.18961803696E-02 2.62701254491E-03 -2.05796085494E-04 1.48228007642E-05 -8.99524545517E-07 3.05752517738E-08 2.33241532643E-09 -1.63651228101E-09 4.10479029951E-10 7.56578933034E-10 3.34120433653E-10 6 Number of nonzero Dij 1 1 3.04819256173E-01 1 2 -1.86159251284E-01 2 2 1.13662727111E-01 3 3 9.04309052733E-02 3 4 2.32721033135E-03 4 4 -1.66727004489E-02 0 nqf. If not zero, Qij's inside rinner are computed using qfcoef's 1 1 0 i j (l(j)) -1.45079016865E-01 Q_int -1.13820910205E-04 -1.17286818500E-04 -1.20858251310E-04 -1.24538420599E-04 -1.28330636038E-04 -1.32238307982E-04 -1.36264950523E-04 -1.40414184647E-04 -1.44689741475E-04 -1.49095465616E-04 -1.53635318608E-04 -1.58313382475E-04 -1.63133863380E-04 -1.68101095401E-04 -1.73219544412E-04 -1.78493812083E-04 -1.83928640007E-04 -1.89528913945E-04 -1.95299668202E-04 -2.01246090135E-04 -2.07373524802E-04 -2.13687479740E-04 -2.20193629901E-04 -2.26897822730E-04 -2.33806083392E-04 -2.40924620170E-04 -2.48259830014E-04 -2.55818304262E-04 -2.63606834535E-04 -2.71632418805E-04 -2.79902267657E-04 -2.88423810722E-04 -2.97204703324E-04 -3.06252833310E-04 -3.15576328100E-04 -3.25183561937E-04 -3.35083163366E-04 -3.45284022929E-04 -3.55795301099E-04 -3.66626436448E-04 -3.77787154062E-04 -3.89287474209E-04 -4.01137721268E-04 -4.13348532925E-04 -4.25930869643E-04 -4.38896024424E-04 -4.52255632853E-04 -4.66021683452E-04 -4.80206528339E-04 -4.94822894207E-04 -5.09883893635E-04 -5.25403036730E-04 -5.41394243129E-04 -5.57871854344E-04 -5.74850646490E-04 -5.92345843384E-04 -6.10373130038E-04 -6.28948666554E-04 -6.48089102430E-04 -6.67811591296E-04 -6.88133806088E-04 -7.09073954665E-04 -7.30650795904E-04 -7.52883656256E-04 -7.75792446808E-04 -7.99397680841E-04 -8.23720491907E-04 -8.48782652448E-04 -8.74606592959E-04 -9.01215421718E-04 -9.28632945094E-04 -9.56883688464E-04 -9.85992917730E-04 -1.01598666148E-03 -1.04689173380E-03 -1.07873575773E-03 -1.11154718945E-03 -1.14535534316E-03 -1.18019041662E-03 -1.21608351756E-03 -1.25306669075E-03 -1.29117294589E-03 -1.33043628635E-03 -1.37089173870E-03 -1.41257538308E-03 -1.45552438448E-03 -1.49977702495E-03 -1.54537273666E-03 -1.59235213596E-03 -1.64075705840E-03 -1.69063059480E-03 -1.74201712826E-03 -1.79496237229E-03 -1.84951341003E-03 -1.90571873452E-03 -1.96362829018E-03 -2.02329351543E-03 -2.08476738650E-03 -2.14810446247E-03 -2.21336093159E-03 -2.28059465890E-03 -2.34986523515E-03 -2.42123402704E-03 -2.49476422898E-03 -2.57052091609E-03 -2.64857109885E-03 -2.72898377907E-03 -2.81183000752E-03 -2.89718294302E-03 -2.98511791322E-03 -3.07571247693E-03 -3.16904648815E-03 -3.26520216187E-03 -3.36426414148E-03 -3.46631956810E-03 -3.57145815160E-03 -3.67977224359E-03 -3.79135691222E-03 -3.90631001891E-03 -4.02473229711E-03 -4.14672743299E-03 -4.27240214819E-03 -4.40186628464E-03 -4.53523289152E-03 -4.67261831428E-03 -4.81414228593E-03 -4.95992802048E-03 -5.11010230859E-03 -5.26479561558E-03 -5.42414218164E-03 -5.58828012443E-03 -5.75735154397E-03 -5.93150262995E-03 -6.11088377138E-03 -6.29564966874E-03 -6.48595944837E-03 -6.68197677953E-03 -6.88386999369E-03 -7.09181220636E-03 -7.30598144139E-03 -7.52656075762E-03 -7.75373837801E-03 -7.98770782117E-03 -8.22866803528E-03 -8.47682353434E-03 -8.73238453674E-03 -8.99556710612E-03 -9.26659329446E-03 -9.54569128726E-03 -9.83309555086E-03 -1.01290469817E-02 -1.04337930576E-02 -1.07475879906E-02 -1.10706928816E-02 -1.14033758766E-02 -1.17459123242E-02 -1.20985849341E-02 -1.24616839372E-02 -1.28355072456E-02 -1.32203606139E-02 -1.36165578004E-02 -1.40244207287E-02 -1.44442796483E-02 -1.48764732951E-02 -1.53213490509E-02 -1.57792631010E-02 -1.62505805905E-02 -1.67356757780E-02 -1.72349321861E-02 -1.77487427491E-02 -1.82775099563E-02 -1.88216459903E-02 -1.93815728605E-02 -1.99577225300E-02 -2.05505370356E-02 -2.11604685994E-02 -2.17879797324E-02 -2.24335433271E-02 -2.30976427400E-02 -2.37807718610E-02 -2.44834351695E-02 -2.52061477757E-02 -2.59494354452E-02 -2.67138346055E-02 -2.74998923326E-02 -2.83081663166E-02 -2.91392248027E-02 -2.99936465070E-02 -3.08720205048E-02 -3.17749460875E-02 -3.27030325875E-02 -3.36568991670E-02 -3.46371745687E-02 -3.56444968241E-02 -3.66795129177E-02 -3.77428784024E-02 -3.88352569628E-02 -3.99573199226E-02 -4.11097456917E-02 -4.22932191486E-02 -4.35084309537E-02 -4.47560767879E-02 -4.60368565126E-02 -4.73514732434E-02 -4.87006323344E-02 -5.00850402648E-02 -5.15054034221E-02 -5.29624267758E-02 -5.44568124336E-02 -5.59892580730E-02 -5.75604552411E-02 -5.91710875133E-02 -6.08218285042E-02 -6.25133397205E-02 -6.42462682474E-02 -6.60212442594E-02 -6.78388783457E-02 -6.96997586398E-02 -7.16044477439E-02 -7.35534794374E-02 -7.55473551585E-02 -7.75865402488E-02 -7.96714599504E-02 -8.18024951431E-02 -8.39799778134E-02 -8.62041862424E-02 -8.84753399039E-02 -9.07935940613E-02 -9.31590340558E-02 -9.55716692743E-02 -9.80314267914E-02 -1.00538144677E-01 -1.03091564963E-01 -1.05691326269E-01 -1.08336956074E-01 -1.11027862645E-01 -1.13763326618E-01 -1.16542492231E-01 -1.19364358227E-01 -1.22227768425E-01 -1.25131401977E-01 -1.28073763335E-01 -1.31053171941E-01 -1.34067751674E-01 -1.37115420083E-01 -1.40193877453E-01 -1.43300595736E-01 -1.46432807425E-01 -1.49587494404E-01 -1.52761376869E-01 -1.55950902392E-01 -1.59152235212E-01 -1.62361245862E-01 -1.65573501253E-01 -1.68784255310E-01 -1.71988440338E-01 -1.75180659236E-01 -1.78355178729E-01 -1.81505923815E-01 -1.84626473582E-01 -1.87710058636E-01 -1.90749560327E-01 -1.93737512023E-01 -1.96666102658E-01 -1.99527182821E-01 -2.02312273629E-01 -2.05012578674E-01 -2.07618999288E-01 -2.10122153430E-01 -2.12512398443E-01 -2.14779857958E-01 -2.16914453198E-01 -2.18905938918E-01 -2.20743944204E-01 -2.22418018303E-01 -2.23917681650E-01 -2.25232482188E-01 -2.26352057034E-01 -2.27266199471E-01 -2.27964931193E-01 -2.28438579616E-01 -2.28677860008E-01 -2.28673962050E-01 -2.28418640354E-01 -2.27904308323E-01 -2.27124134610E-01 -2.26072141287E-01 -2.24743302695E-01 -2.23133643781E-01 -2.21240336598E-01 -2.19061793464E-01 -2.16597755172E-01 -2.13849372471E-01 -2.10819278950E-01 -2.07511653352E-01 -2.03932269292E-01 -2.00088530292E-01 -1.95989488109E-01 -1.91645842341E-01 -1.87069919453E-01 -1.82275629531E-01 -1.77278399326E-01 -1.72095080477E-01 -1.66743832233E-01 -1.61243978439E-01 -1.55615839177E-01 -1.49880538072E-01 -1.44059787036E-01 -1.38175650986E-01 -1.32250295978E-01 -1.26305725059E-01 -1.20363507091E-01 -1.14444504702E-01 -1.08568608432E-01 -1.02754484966E-01 -9.70193480995E-02 -9.13787616864E-02 -8.58464842867E-02 -8.04343654593E-02 -7.51523036583E-02 -7.00082754059E-02 -6.50084448139E-02 -6.01573615754E-02 -5.54582542026E-02 -5.09134235251E-02 -4.65247392572E-02 -4.22942397466E-02 -3.82248318255E-02 -3.43210839447E-02 -3.05901014704E-02 -2.70424681213E-02 -2.36932320043E-02 -2.05629085628E-02 -1.76784660362E-02 -1.50387689185E-02 -1.26414848061E-02 -1.04830514014E-02 -8.55863912918E-03 -6.86210865285E-03 -5.38596275621E-03 -4.12129222638E-03 -3.05771558890E-03 -2.18331280479E-03 -1.48455334980E-03 -9.46219459486E-04 -5.51325745309E-04 -2.81036871279E-04 -1.14585533877E-04 -2.91936146427E-05 -8.07107713996E-11 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2.22044604925E-16 -1.11022302463E-16 -1.11022302463E-16 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1 2 0 i j (l(j)) 9.10170147501E-02 Q_int 7.22168155304E-05 7.44158536493E-05 7.66818444323E-05 7.90168257773E-05 8.14228975766E-05 8.39022236006E-05 8.64570334386E-05 8.90896244982E-05 9.18023640664E-05 9.45976914312E-05 9.74781200698E-05 1.00446239901E-04 1.03504719606E-04 1.06656309024E-04 1.09903841610E-04 1.13250236980E-04 1.16698503523E-04 1.20251741097E-04 1.23913143803E-04 1.27686002850E-04 1.31573709499E-04 1.35579758098E-04 1.39707749210E-04 1.43961392838E-04 1.48344511742E-04 1.52861044857E-04 1.57515050822E-04 1.62310711603E-04 1.67252336236E-04 1.72344364678E-04 1.77591371774E-04 1.82998071345E-04 1.88569320400E-04 1.94310123473E-04 2.00225637092E-04 2.06321174380E-04 2.12602209799E-04 2.19074384035E-04 2.25743509026E-04 2.32615573147E-04 2.39696746550E-04 2.46993386657E-04 2.54512043833E-04 2.62259467210E-04 2.70242610705E-04 2.78468639204E-04 2.86944934938E-04 2.95679104051E-04 3.04678983361E-04 3.13952647326E-04 3.23508415217E-04 3.33354858507E-04 3.43500808479E-04 3.53955364063E-04 3.64727899907E-04 3.75828074685E-04 3.87265839660E-04 3.99051447495E-04 4.11195461329E-04 4.23708764124E-04 4.36602568291E-04 4.49888425596E-04 4.63578237368E-04 4.77684265003E-04 4.92219140785E-04 5.07195879022E-04 5.22627887515E-04 5.38528979367E-04 5.54913385134E-04 5.71795765346E-04 5.89191223381E-04 6.07115318737E-04 6.25584080676E-04 6.44614022283E-04 6.64222154928E-04 6.84426003155E-04 7.05243620011E-04 7.26693602814E-04 7.48795109388E-04 7.71567874770E-04 7.95032228404E-04 8.19209111828E-04 8.44120096885E-04 8.69787404454E-04 8.96233923721E-04 9.23483232018E-04 9.51559615218E-04 9.80488088730E-04 1.01029441909E-03 1.04100514616E-03 1.07264760601E-03 1.10524995436E-03 1.13884119081E-03 1.17345118363E-03 1.20911069538E-03 1.24585140915E-03 1.28370595559E-03 1.32270794069E-03 1.36289197435E-03 1.40429369974E-03 1.44694982347E-03 1.49089814660E-03 1.53617759654E-03 1.58282825977E-03 1.63089141554E-03 1.68040957042E-03 1.73142649385E-03 1.78398725458E-03 1.83813825823E-03 1.89392728570E-03 1.95140353275E-03 2.01061765057E-03 2.07162178740E-03 2.13446963137E-03 2.19921645431E-03 2.26591915686E-03 2.33463631460E-03 2.40542822555E-03 2.47835695871E-03 2.55348640396E-03 2.63088232321E-03 2.71061240280E-03 2.79274630720E-03 2.87735573411E-03 2.96451447083E-03 3.05429845209E-03 3.14678581918E-03 3.24205698056E-03 3.34019467386E-03 3.44128402938E-03 3.54541263499E-03 3.65267060256E-03 3.76315063586E-03 3.87694809998E-03 3.99416109222E-03 4.11489051460E-03 4.23924014782E-03 4.36731672675E-03 4.49923001753E-03 4.63509289613E-03 4.77502142848E-03 4.91913495211E-03 5.06755615930E-03 5.22041118176E-03 5.37782967670E-03 5.53994491445E-03 5.70689386741E-03 5.87881730047E-03 6.05585986272E-03 6.23817018042E-03 6.42590095133E-03 6.61920904005E-03 6.81825557461E-03 7.02320604400E-03 7.23423039664E-03 7.45150313973E-03 7.67520343923E-03 7.90551522051E-03 8.14262726944E-03 8.38673333377E-03 8.63803222462E-03 8.89672791801E-03 9.16302965605E-03 9.43715204772E-03 9.71931516894E-03 1.00097446616E-02 1.03086718316E-02 1.06163337450E-02 1.09329733221E-02 1.12588394305E-02 1.15941869735E-02 1.19392769774E-02 1.22943766739E-02 1.26597595791E-02 1.30357055681E-02 1.34225009436E-02 1.38204384999E-02 1.42298175794E-02 1.46509441228E-02 1.50841307109E-02 1.55296965978E-02 1.59879677341E-02 1.64592767805E-02 1.69439631084E-02 1.74423727891E-02 1.79548585679E-02 1.84817798244E-02 1.90235025150E-02 1.95803990982E-02 2.01528484405E-02 2.07412357010E-02 2.13459521932E-02 2.19673952224E-02 2.26059678959E-02 2.32620789051E-02 2.39361422768E-02 2.46285770902E-02 2.53398071590E-02 2.60702606749E-02 2.68203698096E-02 2.75905702728E-02 2.83813008225E-02 2.91930027249E-02 3.00261191600E-02 3.08810945692E-02 3.17583739416E-02 3.26584020335E-02 3.35816225189E-02 3.45284770647E-02 3.54994043265E-02 3.64948388609E-02 3.75152099475E-02 3.85609403175E-02 3.96324447805E-02 4.07301287474E-02 4.18543866396E-02 4.30056001815E-02 4.41841365684E-02 4.53903465039E-02 4.66245620999E-02 4.78870946332E-02 4.91782321509E-02 5.04982369192E-02 5.18473427075E-02 5.32257519013E-02 5.46336324388E-02 5.60711145617E-02 5.75382873772E-02 5.90351952226E-02 6.05618338292E-02 6.21181462784E-02 6.37040187472E-02 6.53192760385E-02 6.69636768943E-02 6.86369090890E-02 7.03385843036E-02 7.20682327808E-02 7.38252977640E-02 7.56091297251E-02 7.74189803867E-02 7.92539965485E-02 8.11132137297E-02 8.29955496408E-02 8.48997975041E-02 8.68246192437E-02 8.87685385712E-02 9.07299339955E-02 9.27070317943E-02 9.46978989837E-02 9.67004363347E-02 9.87123714862E-02 1.00731252213E-01 1.02754439913E-01 1.04779103388E-01 1.06802212997E-01 1.08820535261E-01 1.10830628037E-01 1.12828836335E-01 1.14811288918E-01 1.16773895794E-01 1.18712346724E-01 1.20622110898E-01 1.22498437913E-01 1.24336360219E-01 1.26130697171E-01 1.27876060884E-01 1.29566864029E-01 1.31197329763E-01 1.32761503962E-01 1.34253269922E-01 1.35666365704E-01 1.36994404279E-01 1.38230896623E-01 1.39369277903E-01 1.40402936857E-01 1.41325248481E-01 1.42129610065E-01 1.42809480624E-01 1.43358423700E-01 1.43770153486E-01 1.44038584155E-01 1.44157882214E-01 1.44122521658E-01 1.43927341602E-01 1.43567605995E-01 1.43039064937E-01 1.42338017049E-01 1.41461372200E-01 1.40406713863E-01 1.39172360234E-01 1.37757423157E-01 1.36161863831E-01 1.34386544163E-01 1.32433272586E-01 1.30304843069E-01 1.28005066050E-01 1.25538789963E-01 1.22911912065E-01 1.20131377310E-01 1.17205164071E-01 1.14142255673E-01 1.10952596812E-01 1.07647034187E-01 1.04237240918E-01 1.00735624624E-01 9.71552194358E-02 9.35095626081E-02 8.98125568621E-02 8.60783201227E-02 8.23210248316E-02 7.85547296018E-02 7.47932065537E-02 7.10497682554E-02 6.73370987433E-02 6.36670936198E-02 6.00507146792E-02 5.64978648808E-02 5.30172897517E-02 4.96165114226E-02 4.63018014661E-02 4.30781984892E-02 3.99495759995E-02 3.69187654146E-02 3.39877381704E-02 3.11578497145E-02 2.84301467082E-02 2.58057369969E-02 2.32862198336E-02 2.08741714259E-02 1.85736781259E-02 1.63909064700E-02 1.43346958071E-02 1.24171554228E-02 1.06542438799E-02 9.04475060136E-03 7.58670209395E-03 6.27734776976E-03 5.11314410582E-03 4.08973689710E-03 3.20194143333E-03 2.44372055864E-03 1.80816072815E-03 1.28744636257E-03 8.72833018623E-04 5.54620145271E-04 3.22124481014E-04 1.63655471106E-04 6.64944451914E-05 1.68796975917E-05 5.49476575351E-11 5.55111512313E-17 0.00000000000E+00 0.00000000000E+00 -5.55111512313E-17 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2.77555756156E-17 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1 3 1 i j (l(j)) 0.00000000000E+00 Q_int 6.13032802919E-07 6.41239722678E-07 6.70744193724E-07 7.01605880941E-07 7.33887190902E-07 7.67653397697E-07 8.02972774544E-07 8.39916731413E-07 8.78559958966E-07 9.18980579073E-07 9.61260302232E-07 1.00548459219E-06 1.05174283809E-06 1.10012853450E-06 1.15073946970E-06 1.20367792254E-06 1.25905086832E-06 1.31697019409E-06 1.37755292380E-06 1.44092145370E-06 1.50720379855E-06 1.57653384902E-06 1.64905164090E-06 1.72490363657E-06 1.80424301932E-06 1.88723000112E-06 1.97403214441E-06 2.06482469859E-06 2.15979095184E-06 2.25912259899E-06 2.36302012612E-06 2.47169321274E-06 2.58536115226E-06 2.70425329157E-06 2.82860949070E-06 2.95868060332E-06 3.09472897916E-06 3.23702898921E-06 3.38586757488E-06 3.54154482197E-06 3.70437456087E-06 3.87468499388E-06 4.05281935106E-06 4.23913657578E-06 4.43401204141E-06 4.63783830044E-06 4.85102586750E-06 5.07400403792E-06 5.30722174324E-06 5.55114844545E-06 5.80627507160E-06 6.07311499071E-06 6.35220503466E-06 6.64410656528E-06 6.94940658940E-06 7.26871892428E-06 7.60268541543E-06 7.95197720925E-06 8.31729608288E-06 8.69937583388E-06 9.09898373216E-06 9.51692203718E-06 9.95402958309E-06 1.04111834349E-05 1.08893006187E-05 1.13893399292E-05 1.19123038185E-05 1.24592403682E-05 1.30312453502E-05 1.36294643790E-05 1.42550951600E-05 1.49093898374E-05 1.55936574461E-05 1.63092664732E-05 1.70576475321E-05 1.78402961553E-05 1.86587757101E-05 1.95147204439E-05 2.04098386623E-05 2.13459160485E-05 2.23248191269E-05 2.33484988804E-05 2.44189945244E-05 2.55384374469E-05 2.67090553206E-05 2.79331763930E-05 2.92132339646E-05 3.05517710606E-05 3.19514453053E-05 3.34150340068E-05 3.49454394618E-05 3.65456944888E-05 3.82189681978E-05 3.99685720091E-05 4.17979659280E-05 4.37107650878E-05 4.57107465711E-05 4.78018565202E-05 4.99882175486E-05 5.22741364653E-05 5.46641123235E-05 5.71628448070E-05 5.97752429676E-05 6.25064343253E-05 6.53617743475E-05 6.83468563189E-05 7.14675216194E-05 7.47298704225E-05 7.81402728317E-05 8.17053804696E-05 8.54321385372E-05 8.93277983583E-05 9.33999304284E-05 9.76564379836E-05 1.02105571110E-04 1.06755941406E-04 1.11616537230E-04 1.16696739528E-04 1.22006338291E-04 1.27555549637E-04 1.33355033547E-04 1.39415912278E-04 1.45749789469E-04 1.52368769962E-04 1.59285480354E-04 1.66513090309E-04 1.74065334647E-04 1.81956536221E-04 1.90201629622E-04 1.98816185712E-04 2.07816437016E-04 2.17219303990E-04 2.27042422179E-04 2.37304170292E-04 2.48023699200E-04 2.59220961878E-04 2.70916744311E-04 2.83132697366E-04 2.95891369648E-04 3.09216241353E-04 3.23131759115E-04 3.37663371869E-04 3.52837567709E-04 3.68681911769E-04 3.85225085097E-04 4.02496924533E-04 4.20528463572E-04 4.39351974196E-04 4.59001009654E-04 4.79510448173E-04 5.00916537547E-04 5.23256940592E-04 5.46570781397E-04 5.70898692330E-04 5.96282861733E-04 6.22767082236E-04 6.50396799603E-04 6.79219162021E-04 7.09283069724E-04 7.40639224838E-04 7.73340181303E-04 8.07440394744E-04 8.42996272104E-04 8.80066220870E-04 9.18710697696E-04 9.58992256178E-04 1.00097559357E-03 1.04472759614E-03 1.09031738289E-03 1.13781634735E-03 1.18729819697E-03 1.23883898997E-03 1.29251716894E-03 1.34841359098E-03 1.40661155374E-03 1.46719681697E-03 1.53025761883E-03 1.59588468652E-03 1.66417124046E-03 1.73521299138E-03 1.80910812942E-03 1.88595730466E-03 1.96586359786E-03 2.04893248085E-03 2.13527176519E-03 2.22499153833E-03 2.31820408593E-03 2.41502379915E-03 2.51556706575E-03 2.61995214338E-03 2.72829901383E-03 2.84072921659E-03 2.95736566004E-03 3.07833240869E-03 3.20375444454E-03 3.33375740073E-03 3.46846726542E-03 3.60801005395E-03 3.75251144691E-03 3.90209639205E-03 4.05688866755E-03 4.21701040430E-03 4.38258156458E-03 4.55371937468E-03 4.73053770869E-03 4.91314642079E-03 5.10165062336E-03 5.29614990795E-03 5.49673750649E-03 5.70349938977E-03 5.91651330052E-03 6.13584771828E-03 6.36156075335E-03 6.59369896734E-03 6.83229611779E-03 7.07737182458E-03 7.32893015620E-03 7.58695813386E-03 7.85142415219E-03 8.12227631528E-03 8.39944068741E-03 8.68281945839E-03 8.97228902380E-03 9.26769798140E-03 9.56886504538E-03 9.87557688135E-03 1.01875858655E-02 1.05046077731E-02 1.08263194018E-02 1.11523561370E-02 1.14823094693E-02 1.18157244717E-02 1.21520972517E-02 1.24908723899E-02 1.28314403828E-02 1.31731351062E-02 1.35152313221E-02 1.38569422501E-02 1.41974172308E-02 1.45357395089E-02 1.48709241674E-02 1.52019162499E-02 1.55275891056E-02 1.58467430016E-02 1.61581040456E-02 1.64603234676E-02 1.67519773129E-02 1.70315666007E-02 1.72975180080E-02 1.75481851395E-02 1.77818504485E-02 1.79967278768E-02 1.81909662827E-02 1.83626537282E-02 1.85098226995E-02 1.86304563329E-02 1.87224957185E-02 1.87838483552E-02 1.88123978239E-02 1.88060147459E-02 1.87625690849E-02 1.86799438473E-02 1.85560502238E-02 1.83888442074E-02 1.81763447064E-02 1.79166531602E-02 1.76079746429E-02 1.72486404236E-02 1.68371319255E-02 1.63721060028E-02 1.58524214213E-02 1.52771664006E-02 1.46456870385E-02 1.39576163992E-02 1.32129040109E-02 1.24118454699E-02 1.15551118086E-02 1.06437782373E-02 9.67935182091E-03 8.66379761005E-03 7.59956269503E-03 6.48959761224E-03 5.33737448963E-03 4.14690128387E-03 2.92273143207E-03 1.66996821996E-03 3.94263156606E-04 -8.98192353976E-04 -2.20068274068E-03 -3.50599205988E-03 -4.80643647756E-03 -6.09390599409E-03 -7.35991588030E-03 -8.59566818418E-03 -9.79212353520E-03 -1.09400833163E-02 -1.20302820924E-02 -1.30534899788E-02 -1.40006244043E-02 -1.48628704751E-02 -1.56318088756E-02 -1.62995499621E-02 -1.68588724082E-02 -1.73033644650E-02 -1.76275656013E-02 -1.78271059963E-02 -1.78988410899E-02 -1.78409781400E-02 -1.76531915227E-02 -1.73367233353E-02 -1.68944657335E-02 -1.63310213671E-02 -1.56527382693E-02 -1.48677156230E-02 -1.39857769623E-02 -1.30184075832E-02 -1.19786532322E-02 -1.08809775115E-02 -9.74107588811E-03 -8.57564471216E-03 -7.40210424451E-03 -6.23827534370E-03 -5.10201018281E-03 -4.01077814130E-03 -2.98120885023E-03 -2.02859526180E-03 -1.16636056748E-03 -4.05493810307E-04 2.46039866455E-04 7.83907210696E-04 1.20802469153E-03 1.52317638185E-03 1.73962060399E-03 1.87367243708E-03 1.93292147179E-03 1.92796554714E-03 1.87246813342E-03 1.78319791694E-03 1.66451900777E-03 1.52166103340E-03 1.36057109017E-03 1.18772560372E-03 1.00990063137E-03 8.33899630212E-04 6.66238433037E-04 5.12788016077E-04 3.78376620561E-04 2.66353919531E-04 1.78121218492E-04 1.12633164338E-04 6.58781358541E-05 3.03464640711E-05 8.62629463844E-06 -6.89314161306E-11 1.11022302463E-16 5.55111512313E-17 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1 4 1 i j (l(j)) 0.00000000000E+00 Q_int 3.44798021608E-07 3.60663613634E-07 3.77259097122E-07 3.94618038775E-07 4.12775548070E-07 4.31768348098E-07 4.51634849640E-07 4.72415228656E-07 4.94151507306E-07 5.16887638699E-07 5.40669595516E-07 5.65545462691E-07 5.91565534345E-07 6.18782415153E-07 6.47251126351E-07 6.77029216598E-07 7.08176877917E-07 7.40757066928E-07 7.74835631645E-07 8.10481444062E-07 8.47766538802E-07 8.86766258119E-07 9.27559403512E-07 9.70228394285E-07 1.01485943334E-06 1.06154268056E-06 1.11037243408E-06 1.16144731989E-06 1.21487049007E-06 1.27074983000E-06 1.32919817518E-06 1.39033353781E-06 1.45427934376E-06 1.52116468032E-06 1.59112455529E-06 1.66430016782E-06 1.74083919161E-06 1.82089607104E-06 1.90463233073E-06 1.99221689922E-06 2.08382644736E-06 2.17964574210E-06 2.27986801638E-06 2.38469535579E-06 2.49433910279E-06 2.60902027939E-06 2.72897002886E-06 2.85443007759E-06 2.98565321784E-06 3.12290381242E-06 3.26645832221E-06 3.41660585753E-06 3.57364875453E-06 3.73790317762E-06 3.90969974917E-06 4.08938420759E-06 4.27731809521E-06 4.47387947720E-06 4.67946369284E-06 4.89448414077E-06 5.11937309951E-06 5.35458258501E-06 5.60058524670E-06 5.85787530387E-06 6.12696952413E-06 6.40840824573E-06 6.70275644577E-06 7.01060485628E-06 7.33257113030E-06 7.66930106008E-06 8.02146984974E-06 8.38978344483E-06 8.77497992110E-06 9.17783093524E-06 9.59914324020E-06 1.00397602679E-05 1.05005637823E-05 1.09824756056E-05 1.14864594215E-05 1.20135226575E-05 1.25647184512E-05 1.31411477029E-05 1.37439612192E-05 1.43743619502E-05 1.50336073261E-05 1.57230116958E-05 1.64439488722E-05 1.71978547897E-05 1.79862302772E-05 1.88106439520E-05 1.96727352404E-05 2.05742175292E-05 2.15168814536E-05 2.25025983283E-05 2.35333237260E-05 2.46111012110E-05 2.57380662332E-05 2.69164501890E-05 2.81485846564E-05 2.94369058115E-05 3.07839590324E-05 3.21924036996E-05 3.36650181995E-05 3.52047051398E-05 3.68144967845E-05 3.84975607174E-05 4.02572057431E-05 4.20968880343E-05 4.40202175351E-05 4.60309646294E-05 4.81330670858E-05 5.03306372878E-05 5.26279697603E-05 5.50295490040E-05 5.75400576479E-05 6.01643849325E-05 6.29076355336E-05 6.57751387413E-05 6.87724580040E-05 7.19054008520E-05 7.51800292120E-05 7.86026701269E-05 8.21799268933E-05 8.59186906306E-05 8.98261522954E-05 9.39098151559E-05 9.81775077386E-05 1.02637397264E-04 1.07298003581E-04 1.12168213626E-04 1.17257296400E-04 1.22574918502E-04 1.28131160218E-04 1.33936532182E-04 1.40001992625E-04 1.46338965232E-04 1.52959357602E-04 1.59875580347E-04 1.67100566826E-04 1.74647793530E-04 1.82531301135E-04 1.90765716227E-04 1.99366273706E-04 2.08348839889E-04 2.17729936304E-04 2.27526764196E-04 2.37757229731E-04 2.48439969918E-04 2.59594379243E-04 2.71240637000E-04 2.83399735335E-04 2.96093507987E-04 3.09344659705E-04 3.23176796346E-04 3.37614455621E-04 3.52683138478E-04 3.68409341084E-04 3.84820587388E-04 4.01945462218E-04 4.19813644875E-04 4.38455943174E-04 4.57904327873E-04 4.78191967434E-04 4.99353263035E-04 5.21423883762E-04 5.44440801885E-04 5.68442328120E-04 5.93468146763E-04 6.19559350581E-04 6.46758475310E-04 6.75109533629E-04 7.04658048421E-04 7.35451085167E-04 7.67537283254E-04 8.00966885993E-04 8.35791769108E-04 8.72065467436E-04 9.09843199579E-04 9.49181890173E-04 9.90140189489E-04 1.03277848998E-03 1.07715893939E-03 1.12334545010E-03 1.17140370412E-03 1.22140115337E-03 1.27340701475E-03 1.32749225933E-03 1.38372959529E-03 1.44219344371E-03 1.50295990685E-03 1.56610672797E-03 1.63171324210E-03 1.69986031686E-03 1.77063028257E-03 1.84410685073E-03 1.92037501989E-03 1.99952096800E-03 2.08163193009E-03 2.16679606036E-03 2.25510227729E-03 2.34664009081E-03 2.44149941013E-03 2.53977033099E-03 2.64154290100E-03 2.74690686154E-03 2.85595136507E-03 2.96876466599E-03 3.08543378388E-03 3.20604413738E-03 3.33067914719E-03 3.45941980666E-03 3.59234421828E-03 3.72952709459E-03 3.87103922190E-03 4.01694688527E-03 4.16731125330E-03 4.32218772128E-03 4.48162521137E-03 4.64566542857E-03 4.81434207142E-03 4.98767999650E-03 5.16569433583E-03 5.34838956696E-03 5.53575853518E-03 5.72778142812E-03 5.92442470299E-03 6.12563996743E-03 6.33136281499E-03 6.54151161719E-03 6.75598627439E-03 6.97466692839E-03 7.19741264040E-03 7.42406003880E-03 7.65442194194E-03 7.88828596208E-03 8.12541309761E-03 8.36553632182E-03 8.60835917757E-03 8.85355438844E-03 9.10076249838E-03 9.34959055313E-03 9.59961083828E-03 9.85035969037E-03 1.01013363990E-02 1.03520022196E-02 1.06017795185E-02 1.08500510732E-02 1.10961595529E-02 1.13394072060E-02 1.15790557829E-02 1.18143267251E-02 1.20444016506E-02 1.22684231703E-02 1.24854960699E-02 1.26946888916E-02 1.28950359532E-02 1.30855398412E-02 1.32651744144E-02 1.34328883554E-02 1.35876093048E-02 1.37282486130E-02 1.38537067414E-02 1.39628793418E-02 1.40546640387E-02 1.41279679363E-02 1.41817158629E-02 1.42148593603E-02 1.42263864184E-02 1.42153319438E-02 1.41807889396E-02 1.41219203656E-02 1.40379716286E-02 1.39282836404E-02 1.37923063653E-02 1.36296127572E-02 1.34399129701E-02 1.32230687040E-02 1.29791075258E-02 1.27082369831E-02 1.24108583067E-02 1.20875794715E-02 1.17392273658E-02 1.13668587962E-02 1.09717700319E-02 1.05555045780E-02 1.01198588480E-02 9.66688539342E-03 9.19889334264E-03 8.71844569623E-03 8.22835312929E-03 7.73166396324E-03 7.23164998687E-03 6.73178783471E-03 6.23573566826E-03 5.74730495371E-03 5.27042718959E-03 4.80911550907E-03 4.36742116515E-03 3.94938500263E-03 3.55898412819E-03 3.20007410861E-03 2.87632715668E-03 2.59116690207E-03 2.34770049076E-03 2.14864890762E-03 1.99627657120E-03 1.89232140490E-03 1.83792674152E-03 1.83357656552E-03 1.87903573696E-03 1.97329696882E-03 2.11453644394E-03 2.30008005519E-03 2.52638233215E-03 2.78902017685E-03 3.08270356993E-03 3.40130542625E-03 3.73791277588E-03 4.08490142377E-03 4.43403619920E-03 4.77659884654E-03 5.10354553162E-03 5.40569584200E-03 5.67395504422E-03 5.89957121926E-03 6.07442872368E-03 6.19137920420E-03 6.24461111183E-03 6.23005829533E-03 6.14584777282E-03 5.99278614914E-03 5.77488332073E-03 5.49991103780E-03 5.17999252927E-03 4.82165754940E-03 4.43364045557E-03 4.02700624757E-03 3.61526607438E-03 3.20333452013E-03 2.79656212915E-03 2.40061257670E-03 2.02130797600E-03 1.66443942462E-03 1.33553989406E-03 1.03961661515E-03 7.80840204096E-04 5.62187919688E-04 3.85038654669E-04 2.48717563043E-04 1.49988631226E-04 8.24940451994E-05 3.61399566297E-05 9.85591113506E-06 8.01300137354E-11 1.66533453694E-16 5.55111512313E-17 -5.55111512313E-17 5.55111512313E-17 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2 2 0 i j (l(j)) -5.71067389214E-02 Q_int -4.58196977850E-05 -4.72149285869E-05 -4.86526389444E-05 -5.01341218384E-05 -5.16607095827E-05 -5.32337750193E-05 -5.48547327496E-05 -5.65250404031E-05 -5.82461999447E-05 -6.00197590212E-05 -6.18473123489E-05 -6.37305031433E-05 -6.56710245919E-05 -6.76706213715E-05 -6.97310912120E-05 -7.18542865064E-05 -7.40421159711E-05 -7.62965463550E-05 -7.86196042012E-05 -8.10133776613E-05 -8.34800183656E-05 -8.60217433483E-05 -8.86408370326E-05 -9.13396532744E-05 -9.41206174685E-05 -9.69862287183E-05 -9.99390620706E-05 -1.02981770818E-04 -1.06117088873E-04 -1.09347833209E-04 -1.12676906377E-04 -1.16107299103E-04 -1.19642092956E-04 -1.23284463101E-04 -1.27037681135E-04 -1.30905118003E-04 -1.34890247012E-04 -1.38996646926E-04 -1.43228005156E-04 -1.47588121055E-04 -1.52080909297E-04 -1.56710403369E-04 -1.61480759163E-04 -1.66396258680E-04 -1.71461313838E-04 -1.76680470400E-04 -1.82058412020E-04 -1.87599964406E-04 -1.93310099610E-04 -1.99193940449E-04 -2.05256765053E-04 -2.11504011553E-04 -2.17941282909E-04 -2.24574351876E-04 -2.31409166131E-04 -2.38451853539E-04 -2.45708727584E-04 -2.53186292960E-04 -2.60891251330E-04 -2.68830507250E-04 -2.77011174279E-04 -2.85440581262E-04 -2.94126278804E-04 -3.03076045934E-04 -3.12297896965E-04 -3.21800088565E-04 -3.31591127025E-04 -3.41679775749E-04 -3.52075062970E-04 -3.62786289678E-04 -3.73823037800E-04 -3.85195178605E-04 -3.96912881368E-04 -4.08986622280E-04 -4.21427193624E-04 -4.34245713216E-04 -4.47453634130E-04 -4.61062754694E-04 -4.75085228791E-04 -4.89533576452E-04 -5.04420694758E-04 -5.19759869065E-04 -5.35564784542E-04 -5.51849538057E-04 -5.68628650398E-04 -5.85917078848E-04 -6.03730230126E-04 -6.22083973692E-04 -6.40994655443E-04 -6.60479111798E-04 -6.80554684178E-04 -7.01239233916E-04 -7.22551157568E-04 -7.44509402684E-04 -7.67133484004E-04 -7.90443500123E-04 -8.14460150625E-04 -8.39204753694E-04 -8.64699264223E-04 -8.90966292423E-04 -9.18029122959E-04 -9.45911734610E-04 -9.74638820474E-04 -1.00423580873E-03 -1.03472888400E-03 -1.06614500920E-03 -1.09851194815E-03 -1.13185828861E-03 -1.16621346612E-03 -1.20160778831E-03 -1.23807246004E-03 -1.27563960902E-03 -1.31434231229E-03 -1.35421462327E-03 -1.39529159961E-03 -1.43760933167E-03 -1.48120497186E-03 -1.52611676463E-03 -1.57238407730E-03 -1.62004743163E-03 -1.66914853624E-03 -1.71973031975E-03 -1.77183696490E-03 -1.82551394333E-03 -1.88080805136E-03 -1.93776744658E-03 -1.99644168528E-03 -2.05688176085E-03 -2.11914014306E-03 -2.18327081817E-03 -2.24932933012E-03 -2.31737282251E-03 -2.38746008160E-03 -2.45965158024E-03 -2.53400952273E-03 -2.61059789072E-03 -2.68948248994E-03 -2.77073099804E-03 -2.85441301330E-03 -2.94060010435E-03 -3.02936586081E-03 -3.12078594494E-03 -3.21493814419E-03 -3.31190242475E-03 -3.41176098593E-03 -3.51459831552E-03 -3.62050124602E-03 -3.72955901174E-03 -3.84186330672E-03 -3.95750834345E-03 -4.07659091241E-03 -4.19921044224E-03 -4.32546906074E-03 -4.45547165630E-03 -4.58932594011E-03 -4.72714250874E-03 -4.86903490715E-03 -5.01511969216E-03 -5.16551649608E-03 -5.32034809052E-03 -5.47974045032E-03 -5.64382281738E-03 -5.81272776426E-03 -5.98659125755E-03 -6.16555272065E-03 -6.34975509602E-03 -6.53934490647E-03 -6.73447231551E-03 -6.93529118646E-03 -7.14195914001E-03 -7.35463761012E-03 -7.57349189792E-03 -7.79869122327E-03 -8.03040877374E-03 -8.26882175067E-03 -8.51411141181E-03 -8.76646311038E-03 -9.02606632984E-03 -9.29311471415E-03 -9.56780609293E-03 -9.85034250090E-03 -1.01409301912E-02 -1.04397796420E-02 -1.07471055554E-02 -1.10631268482E-02 -1.13880666342E-02 -1.17221521962E-02 -1.20656149477E-02 -1.24186903832E-02 -1.27816180160E-02 -1.31546413023E-02 -1.35380075511E-02 -1.39319678181E-02 -1.43367767823E-02 -1.47526926050E-02 -1.51799767680E-02 -1.56188938916E-02 -1.60697115290E-02 -1.65326999364E-02 -1.70081318166E-02 -1.74962820345E-02 -1.79974273026E-02 -1.85118458336E-02 -1.90398169591E-02 -1.95816207104E-02 -2.01375373614E-02 -2.07078469279E-02 -2.12928286238E-02 -2.18927602682E-02 -2.25079176434E-02 -2.31385737985E-02 -2.37849982963E-02 -2.44474564001E-02 -2.51262081966E-02 -2.58215076515E-02 -2.65336015945E-02 -2.72627286284E-02 -2.80091179600E-02 -2.87729881478E-02 -2.95545457627E-02 -3.03539839571E-02 -3.11714809389E-02 -3.20071983448E-02 -3.28612795105E-02 -3.37338476318E-02 -3.46250038132E-02 -3.55348250003E-02 -3.64633617914E-02 -3.74106361242E-02 -3.83766388365E-02 -3.93613270938E-02 -4.03646216857E-02 -4.13864041847E-02 -4.24265139690E-02 -4.34847451058E-02 -4.45608430972E-02 -4.56545014879E-02 -4.67653583365E-02 -4.78929925550E-02 -4.90369201183E-02 -5.01965901527E-02 -5.13713809077E-02 -5.25605956229E-02 -5.37634583011E-02 -5.49791094008E-02 -5.62066014651E-02 -5.74448947066E-02 -5.86928525696E-02 -5.99492372968E-02 -6.12127055280E-02 -6.24818039649E-02 -6.37549651390E-02 -6.50305033237E-02 -6.63066106371E-02 -6.75813533861E-02 -6.88526687075E-02 -7.01183615681E-02 -7.13761021891E-02 -7.26234239674E-02 -7.38577219704E-02 -7.50762520881E-02 -7.62761309284E-02 -7.74543365509E-02 -7.86077101341E-02 -7.97329586797E-02 -8.08266588572E-02 -8.18852620980E-02 -8.29051010476E-02 -8.38823974845E-02 -8.48132718170E-02 -8.56937542611E-02 -8.65197978020E-02 -8.72872930338E-02 -8.79920849608E-02 -8.86299918346E-02 -8.91968260834E-02 -8.96884173717E-02 -9.01006378085E-02 -9.04294292926E-02 -9.06708329555E-02 -9.08210206288E-02 -9.08763282221E-02 -9.08332908565E-02 -9.06886795517E-02 -9.04395392124E-02 -9.00832276073E-02 -8.96174549756E-02 -8.90403238368E-02 -8.83503685183E-02 -8.75465938545E-02 -8.66285124520E-02 -8.55961798565E-02 -8.44502269084E-02 -8.31918885231E-02 -8.18230281023E-02 -8.03461567527E-02 -7.87644464813E-02 -7.70817365435E-02 -7.53025321466E-02 -7.34319947647E-02 -7.14759233941E-02 -6.94407261878E-02 -6.73333820386E-02 -6.51613918543E-02 -6.29327194634E-02 -6.06557223293E-02 -5.83390725136E-02 -5.59916686286E-02 -5.36225398407E-02 -5.12407433300E-02 -4.88552569729E-02 -4.64748693785E-02 -4.41080697721E-02 -4.17629405687E-02 -3.94470557974E-02 -3.71673888171E-02 -3.49302329853E-02 -3.27411390907E-02 -3.06048734194E-02 -2.85254002827E-02 -2.65058926668E-02 -2.45487743672E-02 -2.26557965235E-02 -2.08281508596E-02 -1.90666211583E-02 -1.73717735351E-02 -1.57441849269E-02 -1.41847078654E-02 -1.26947680519E-02 -1.12766894940E-02 -9.93403999533E-03 -8.67198761101E-03 -7.49765630531E-03 -6.42046643703E-03 -5.43935098069E-03 -4.55275936102E-03 -3.75865280547E-03 -3.05449927487E-03 -2.43726792104E-03 -1.90342304058E-03 -1.44891758209E-03 -1.06918636887E-03 -7.59139322792E-04 -5.13155117855E-04 -3.25075854452E-04 -1.88203527519E-04 -9.52992645311E-05 -3.85865322027E-05 -9.75975333711E-06 -3.65347196940E-11 -5.55111512313E-17 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 5.55111512313E-17 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 -4.16333634234E-17 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2 3 1 i j (l(j)) 0.00000000000E+00 Q_int -3.86322807616E-07 -4.04098301052E-07 -4.22691485951E-07 -4.42139961802E-07 -4.62483055829E-07 -4.83761902291E-07 -5.06019525414E-07 -5.29300926120E-07 -5.53653172728E-07 -5.79125495811E-07 -6.05769387390E-07 -6.33638704672E-07 -6.62789778535E-07 -6.93281526975E-07 -7.25175573748E-07 -7.58536372429E-07 -7.93431336154E-07 -8.29930973287E-07 -8.68109029293E-07 -9.08042635094E-07 -9.49812462198E-07 -9.93502884922E-07 -1.03920215002E-06 -1.08700255406E-06 -1.13700062889E-06 -1.18929733558E-06 -1.24399826718E-06 -1.30121386079E-06 -1.36105961923E-06 -1.42365634287E-06 -1.48913037199E-06 -1.55761384018E-06 -1.62924493932E-06 -1.70416819658E-06 -1.78253476404E-06 -1.86450272153E-06 -1.95023739316E-06 -2.03991167831E-06 -2.13370639764E-06 -2.23181065480E-06 -2.33442221464E-06 -2.44174789844E-06 -2.55400399725E-06 -2.67141670385E-06 -2.79422256435E-06 -2.92266895018E-06 -3.05701455161E-06 -3.19752989341E-06 -3.34449787399E-06 -3.49821432885E-06 -3.65898861951E-06 -3.82714424903E-06 -4.00301950534E-06 -4.18696813356E-06 -4.37936003863E-06 -4.58058201965E-06 -4.79103853720E-06 -5.01115251522E-06 -5.24136617901E-06 -5.48214193074E-06 -5.73396326439E-06 -5.99733572164E-06 -6.27278789068E-06 -6.56087244970E-06 -6.86216725707E-06 -7.17727649028E-06 -7.50683183574E-06 -7.85149373165E-06 -8.21195266626E-06 -8.58893053403E-06 -8.98318205199E-06 -9.39549623911E-06 -9.82669796132E-06 -1.02776495450E-05 -1.07492524620E-05 -1.12424490889E-05 -1.17582245446E-05 -1.22976086079E-05 -1.28616777207E-05 -1.34515570788E-05 -1.40684228140E-05 -1.47135042730E-05 -1.53880863950E-05 -1.60935121939E-05 -1.68311853488E-05 -1.76025729068E-05 -1.84092081037E-05 -1.92526933075E-05 -2.01347030884E-05 -2.10569874226E-05 -2.20213750333E-05 -2.30297768765E-05 -2.40841897756E-05 -2.51867002121E-05 -2.63394882789E-05 -2.75448318007E-05 -2.88051106314E-05 -3.01228111323E-05 -3.15005308403E-05 -3.29409833333E-05 -3.44470032993E-05 -3.60215518184E-05 -3.76677218660E-05 -3.93887440436E-05 -4.11879925493E-05 -4.30689913931E-05 -4.50354208698E-05 -4.70911242961E-05 -4.92401150238E-05 -5.14865837375E-05 -5.38349060478E-05 -5.62896503915E-05 -5.88555862468E-05 -6.15376926777E-05 -6.43411672170E-05 -6.72714350996E-05 -7.03341588583E-05 -7.35352482938E-05 -7.68808708309E-05 -8.03774622733E-05 -8.40317379696E-05 -8.78507044028E-05 -9.18416712164E-05 -9.60122636894E-05 -1.00370435674E-04 -1.04924483005E-04 -1.09683057406E-04 -1.14655180880E-04 -1.19850260630E-04 -1.25278104497E-04 -1.30948936930E-04 -1.36873415521E-04 -1.43062648085E-04 -1.49528210322E-04 -1.56282164057E-04 -1.63337076077E-04 -1.70706037563E-04 -1.78402684135E-04 -1.86441216516E-04 -1.94836421813E-04 -2.03603695429E-04 -2.12759063603E-04 -2.22319206583E-04 -2.32301482431E-04 -2.42723951452E-04 -2.53605401252E-04 -2.64965372408E-04 -2.76824184747E-04 -2.89202964213E-04 -3.02123670315E-04 -3.15609124123E-04 -3.29683036795E-04 -3.44370038611E-04 -3.59695708460E-04 -3.75686603760E-04 -3.92370290754E-04 -4.09775375138E-04 -4.27931532943E-04 -4.46869541633E-04 -4.66621311314E-04 -4.87219915988E-04 -5.08699624756E-04 -5.31095932853E-04 -5.54445592418E-04 -5.78786642852E-04 -6.04158440640E-04 -6.30601688471E-04 -6.58158463483E-04 -6.86872244465E-04 -7.16787937790E-04 -7.47951901869E-04 -7.80411969885E-04 -8.14217470542E-04 -8.49419246537E-04 -8.86069670464E-04 -9.24222657788E-04 -9.63933676561E-04 -1.00525975346E-03 -1.04825947574E-03 -1.09299298865E-03 -1.13952198786E-03 -1.18790970625E-03 -1.23822089474E-03 -1.29052179626E-03 -1.34488011252E-03 -1.40136496265E-03 -1.46004683320E-03 -1.52099751850E-03 -1.58429005080E-03 -1.64999861912E-03 -1.71819847596E-03 -1.78896583099E-03 -1.86237773048E-03 -1.93851192159E-03 -2.01744670026E-03 -2.09926074152E-03 -2.18403291100E-03 -2.27184205628E-03 -2.36276677670E-03 -2.45688517030E-03 -2.55427455626E-03 -2.65501117143E-03 -2.75916983926E-03 -2.86682360959E-03 -2.97804336761E-03 -3.09289741020E-03 -3.21145098801E-03 -3.33376581152E-03 -3.45989951921E-03 -3.58990510620E-03 -3.72383031156E-03 -3.86171696249E-03 -4.00360027383E-03 -4.14950810118E-03 -4.29946014616E-03 -4.45346711227E-03 -4.61152981034E-03 -4.77363821211E-03 -4.93977045131E-03 -5.10989177141E-03 -5.28395341976E-03 -5.46189148792E-03 -5.64362569862E-03 -5.82905814001E-03 -6.01807194840E-03 -6.21052994135E-03 -6.40627320338E-03 -6.60511962737E-03 -6.80686241562E-03 -7.01126854494E-03 -7.21807720172E-03 -7.42699819322E-03 -7.63771034308E-03 -7.84985987977E-03 -8.06305882832E-03 -8.27688341681E-03 -8.49087251095E-03 -8.70452609118E-03 -8.91730378910E-03 -9.12862350106E-03 -9.33786009939E-03 -9.54434426315E-03 -9.74736145269E-03 -9.94615105418E-03 -1.01399057226E-02 -1.03277709541E-02 -1.05088449195E-02 -1.06821785954E-02 -1.08467762291E-02 -1.10015961757E-02 -1.11455521500E-02 -1.12775149344E-02 -1.13963145874E-02 -1.15007431975E-02 -1.15895582289E-02 -1.16614865044E-02 -1.17152288720E-02 -1.17494655998E-02 -1.17628625428E-02 -1.17540781219E-02 -1.17217711535E-02 -1.16646095616E-02 -1.15812800015E-02 -1.14704984131E-02 -1.13310215190E-02 -1.11616592670E-02 -1.09612882107E-02 -1.07288658037E-02 -1.04634455728E-02 -1.01641931144E-02 -9.83040284392E-03 -9.46151540403E-03 -9.05713561834E-03 -8.61705085060E-03 -8.14124960564E-03 -7.62994018068E-03 -7.08356914731E-03 -6.50283941592E-03 -5.88872760457E-03 -5.24250040533E-03 -4.56572961246E-03 -3.86030544937E-03 -3.12844780679E-03 -2.37271498197E-03 -1.59600949129E-03 -8.01580515547E-04 6.97746952849E-06 8.25730323896E-04 1.65041457228E-03 2.47645284945E-03 3.29897484918E-03 4.11284412158E-03 4.91269100765E-03 5.69295192954E-03 6.44791516996E-03 7.17177317391E-03 7.85868128958E-03 8.50282273492E-03 9.09847943024E-03 9.64010817934E-03 1.01224215109E-02 1.05404723135E-02 1.08897412110E-02 1.11662254397E-02 1.13665277977E-02 1.14879440608E-02 1.15285470856E-02 1.14872656693E-02 1.13639561013E-02 1.11594642372E-02 1.08756758547E-02 1.05155530110E-02 1.00831541310E-02 9.58363560576E-03 9.02323277681E-03 8.40921833585E-03 7.74983636331E-03 7.05421048166E-03 6.33222489576E-03 5.59437743665E-03 4.85160411375E-03 4.11507510880E-03 3.39596261262E-03 2.70518140928E-03 2.05310365138E-03 1.44924984487E-03 9.01958674541E-04 4.18038955458E-04 2.40769606169E-06 -3.42280986722E-04 -6.16010545170E-04 -8.21773831756E-04 -9.65934682727E-04 -1.05857077137E-03 -1.10446901665E-03 -1.11023692293E-03 -1.08431621818E-03 -1.03698144269E-03 -9.70989209494E-04 -8.89624311728E-04 -7.96603395556E-04 -6.95954299473E-04 -5.91870641243E-04 -4.88541659210E-04 -3.89957892621E-04 -2.99693951891E-04 -2.20670390313E-04 -1.54897549548E-04 -1.03205218014E-04 -6.49630207807E-05 -3.77976585396E-05 -1.73144663028E-05 -4.89265883286E-06 3.88495902115E-11 5.55111512313E-17 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 -2.77555756156E-17 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2 4 1 i j (l(j)) 0.00000000000E+00 Q_int -2.17520718188E-07 -2.27529740508E-07 -2.37999223806E-07 -2.48950343981E-07 -2.60405250200E-07 -2.72387109590E-07 -2.84920153967E-07 -2.98029728720E-07 -3.11742343925E-07 -3.26085727809E-07 -3.41088882651E-07 -3.56782143263E-07 -3.73197238125E-07 -3.90367353344E-07 -4.08327199523E-07 -4.27113081697E-07 -4.46762972477E-07 -4.67316588529E-07 -4.88815470557E-07 -5.11303066954E-07 -5.34824821260E-07 -5.59428263637E-07 -5.85163106518E-07 -6.12081344624E-07 -6.40237359563E-07 -6.69688029196E-07 -7.00492842008E-07 -7.32714016694E-07 -7.66416627212E-07 -8.01668733540E-07 -8.38541518401E-07 -8.77109430223E-07 -9.17450332624E-07 -9.59645660709E-07 -1.00378058449E-06 -1.04994417977E-06 -1.09822960677E-06 -1.14873429693E-06 -1.20156014823E-06 -1.25681372932E-06 -1.31460649303E-06 -1.37505499951E-06 -1.43828114961E-06 -1.50441242874E-06 -1.57358216192E-06 -1.64592978034E-06 -1.72160110008E-06 -1.80074861339E-06 -1.88353179326E-06 -1.97011741174E-06 -2.06067987273E-06 -2.15540155979E-06 -2.25447319973E-06 -2.35809424260E-06 -2.46647325892E-06 -2.57982835483E-06 -2.69838760596E-06 -2.82238951092E-06 -2.95208346524E-06 -3.08773025666E-06 -3.22960258272E-06 -3.37798559170E-06 -3.53317744780E-06 -3.69548992186E-06 -3.86524900847E-06 -4.04279557088E-06 -4.22848601478E-06 -4.42269299232E-06 -4.62580613757E-06 -4.83823283501E-06 -5.06039902221E-06 -5.29275002845E-06 -5.53575145077E-06 -5.78989006896E-06 -6.05567480137E-06 -6.33363770321E-06 -6.62433500916E-06 -6.92834822225E-06 -7.24628525107E-06 -7.57878159721E-06 -7.92650159527E-06 -8.29013970757E-06 -8.67042187604E-06 -9.06810693348E-06 -9.48398807705E-06 -9.91889440630E-06 -1.03736925287E-05 -1.08492882354E-05 -1.13466282504E-05 -1.18667020554E-05 -1.24105437952E-05 -1.29792342646E-05 -1.35739029828E-05 -1.41957303565E-05 -1.48459499370E-05 -1.55258507748E-05 -1.62367798752E-05 -1.69801447590E-05 -1.77574161337E-05 -1.85701306781E-05 -1.94198939460E-05 -2.03083833927E-05 -2.12373515309E-05 -2.22086292185E-05 -2.32241290863E-05 -2.42858491092E-05 -2.53958763268E-05 -2.65563907193E-05 -2.77696692452E-05 -2.90380900461E-05 -3.03641368247E-05 -3.17504034038E-05 -3.31995984716E-05 -3.47145505208E-05 -3.62982129884E-05 -3.79536696036E-05 -3.96841399508E-05 -4.14929852556E-05 -4.33837144019E-05 -4.53599901864E-05 -4.74256358214E-05 -4.95846416910E-05 -5.18411723719E-05 -5.41995739246E-05 -5.66643814665E-05 -5.92403270334E-05 -6.19323477390E-05 -6.47455942422E-05 -6.76854395293E-05 -7.07574880224E-05 -7.39675850210E-05 -7.73218264872E-05 -8.08265691830E-05 -8.44884411679E-05 -8.83143526677E-05 -9.23115073197E-05 -9.64874138064E-05 -1.00849897883E-04 -1.05407114808E-04 -1.10167562183E-04 -1.15140093212E-04 -1.20333930379E-04 -1.25758679562E-04 -1.31424344573E-04 -1.37341342147E-04 -1.43520517358E-04 -1.49973159498E-04 -1.56711018383E-04 -1.63746321118E-04 -1.71091789299E-04 -1.78760656657E-04 -1.86766687137E-04 -1.95124193412E-04 -2.03848055802E-04 -2.12953741621E-04 -2.22457324902E-04 -2.32375506508E-04 -2.42725634595E-04 -2.53525725417E-04 -2.64794484429E-04 -2.76551327671E-04 -2.88816403390E-04 -3.01610613860E-04 -3.14955637362E-04 -3.28873950261E-04 -3.43388849129E-04 -3.58524472852E-04 -3.74305824651E-04 -3.90758793929E-04 -4.07910177866E-04 -4.25787702673E-04 -4.44420044378E-04 -4.63836849057E-04 -4.84068752365E-04 -5.05147398234E-04 -5.27105456597E-04 -5.49976639965E-04 -5.73795718685E-04 -5.98598534695E-04 -6.24422013555E-04 -6.51304174541E-04 -6.79284138563E-04 -7.08402133637E-04 -7.38699497642E-04 -7.70218678056E-04 -8.03003228355E-04 -8.37097800724E-04 -8.72548134721E-04 -9.09401041490E-04 -9.47704383117E-04 -9.87507046669E-04 -1.02885891246E-03 -1.07181081600E-03 -1.11641450321E-03 -1.16272257811E-03 -1.21078844269E-03 -1.26066622807E-03 -1.31241071644E-03 -1.36607725303E-03 -1.42172164744E-03 -1.47940006348E-03 -1.53916889683E-03 -1.60108463963E-03 -1.66520373120E-03 -1.73158239395E-03 -1.80027645365E-03 -1.87134114302E-03 -1.94483088779E-03 -2.02079907425E-03 -2.09929779718E-03 -2.18037758730E-03 -2.26408711724E-03 -2.35047288488E-03 -2.43957887326E-03 -2.53144618603E-03 -2.62611265741E-03 -2.72361243593E-03 -2.82397554103E-03 -2.92722739167E-03 -3.03338830652E-03 -3.14247297481E-03 -3.25448989766E-03 -3.36944079948E-03 -3.48732000924E-03 -3.60811381176E-03 -3.73179976920E-03 -3.85834601337E-03 -3.98771050959E-03 -4.11984029326E-03 -4.25467068058E-03 -4.39212445548E-03 -4.53211103480E-03 -4.67452561480E-03 -4.81924830218E-03 -4.96614323359E-03 -5.11505768821E-03 -5.26582119854E-03 -5.41824466552E-03 -5.57211948456E-03 -5.72721669020E-03 -5.88328612788E-03 -6.04005566215E-03 -6.19723043180E-03 -6.35449216339E-03 -6.51149855551E-03 -6.66788274752E-03 -6.82325288743E-03 -6.97719181458E-03 -7.12925687432E-03 -7.27897988245E-03 -7.42586725868E-03 -7.56940034907E-03 -7.70903595849E-03 -7.84420711496E-03 -7.97432408821E-03 -8.09877568556E-03 -8.21693084828E-03 -8.32814057174E-03 -8.43174017248E-03 -8.52705192446E-03 -8.61338808615E-03 -8.69005433824E-03 -8.75635365035E-03 -8.81159059205E-03 -8.85507610094E-03 -8.88613271630E-03 -8.90410028279E-03 -8.90834212295E-03 -8.89825167151E-03 -8.87325955733E-03 -8.83284111107E-03 -8.77652426778E-03 -8.70389782397E-03 -8.61461999807E-03 -8.50842723166E-03 -8.38514315650E-03 -8.24468763940E-03 -8.08708580303E-03 -7.91247690685E-03 -7.72112295766E-03 -7.51341690465E-03 -7.28989025977E-03 -7.05121997008E-03 -6.79823435593E-03 -6.53191791741E-03 -6.25341480111E-03 -5.96403071237E-03 -5.66523305260E-03 -5.35864906058E-03 -5.04606173866E-03 -4.72940335221E-03 -4.41074630299E-03 -4.09229119487E-03 -3.77635193528E-03 -3.46533774628E-03 -3.16173199806E-03 -2.86806782309E-03 -2.58690052291E-03 -2.32077684024E-03 -2.07220123803E-03 -1.84359940233E-03 -1.63727926777E-03 -1.45538995234E-03 -1.29987907981E-03 -1.17244906374E-03 -1.07451302355E-03 -1.00715110047E-03 -9.71068035732E-04 -9.66552964636E-04 -9.93442465613E-04 -1.05108798052E-03 -1.13832879070E-03 -1.25347178977E-03 -1.39427933850E-03 -1.55796651756E-03 -1.74120911030E-03 -1.94016365000E-03 -2.15050085332E-03 -2.36745373584E-03 -2.58588166603E-03 -2.80035156156E-03 -3.00523736741E-03 -3.19483887688E-03 -3.36352086449E-03 -3.50587338905E-03 -3.61689399231E-03 -3.69219235447E-03 -3.72821776213E-03 -3.72250948279E-03 -3.67396980283E-03 -3.58315905143E-03 -3.45261137183E-03 -3.28716928212E-03 -3.09433412783E-03 -2.87820719977E-03 -2.64421392031E-03 -2.39916357756E-03 -2.15129885435E-03 -1.90363537901E-03 -1.65943826496E-03 -1.42214336777E-03 -1.19525969327E-03 -9.82251640195E-04 -7.86399878371E-04 -6.10639829095E-04 -4.57376925271E-04 -3.28278093397E-04 -2.24039226139E-04 -1.44128814352E-04 -8.65083943135E-05 -4.73310562234E-05 -2.06199990807E-05 -5.59007229545E-06 -4.51612081065E-11 0.00000000000E+00 0.00000000000E+00 5.55111512313E-17 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 3 3 1 i j (l(j)) 8.62605628449E-02 Q_int 2.41510238144E-08 2.56442133682E-08 2.72297152928E-08 2.89132358595E-08 3.07008340064E-08 3.25989431292E-08 3.46143942158E-08 3.67544404117E-08 3.90267831007E-08 4.14395995975E-08 4.40015725493E-08 4.67219211535E-08 4.96104343028E-08 5.26775057764E-08 5.59341716042E-08 5.93921497378E-08 6.30638821701E-08 6.69625796551E-08 7.11022691885E-08 7.54978444181E-08 8.01651191663E-08 8.51208842555E-08 9.03829678399E-08 9.59702994613E-08 1.01902978056E-07 1.08202344160E-07 1.14891056565E-07 1.21993173709E-07 1.29534240084E-07 1.37541377971E-07 1.46043384841E-07 1.55070836757E-07 1.64656198154E-07 1.74833938386E-07 1.85640655466E-07 1.97115207427E-07 2.09298851789E-07 2.22235393612E-07 2.35971342687E-07 2.50556080406E-07 2.66042036915E-07 2.82484879191E-07 2.99943710693E-07 3.18481283327E-07 3.38164222453E-07 3.59063265760E-07 3.81253516848E-07 4.04814714419E-07 4.29831518052E-07 4.56393811554E-07 4.84597024996E-07 5.14542476558E-07 5.46337735413E-07 5.80097006929E-07 6.15941541573E-07 6.54000068959E-07 6.94409258587E-07 7.37314208903E-07 7.82868966435E-07 8.31237076817E-07 8.82592169683E-07 9.37118579489E-07 9.95012004472E-07 1.05648020607E-06 1.12174375128E-06 1.19103680059E-06 1.26460794430E-06 1.34272109005E-06 1.42565640493E-06 1.51371131526E-06 1.60720156771E-06 1.70646235542E-06 1.81184951322E-06 1.92374078592E-06 2.04253717442E-06 2.16866436412E-06 2.30257424084E-06 2.44474649940E-06 2.59569035071E-06 2.75594633309E-06 2.92608823444E-06 3.10672513176E-06 3.29850355532E-06 3.50210978487E-06 3.71827228607E-06 3.94776429549E-06 4.19140656335E-06 4.45007026329E-06 4.72468007955E-06 5.01621748209E-06 5.32572420110E-06 5.65430591287E-06 6.00313614977E-06 6.37346044799E-06 6.76660074705E-06 7.18396005656E-06 7.62702740609E-06 8.09738309515E-06 8.59670426142E-06 9.12677078612E-06 9.68947155696E-06 1.02868111097E-05 1.09209166713E-05 1.15940456283E-05 1.23085934464E-05 1.30671020670E-05 1.38722688100E-05 1.47269558131E-05 1.56342000383E-05 1.65972238800E-05 1.76194464110E-05 1.87044953018E-05 1.98562194558E-05 2.10787024001E-05 2.23762764780E-05 2.37535378894E-05 2.52153626288E-05 2.67669233740E-05 2.84137073806E-05 3.01615354405E-05 3.20165819673E-05 3.39853962732E-05 3.60749251069E-05 3.82925365245E-05 4.06460451720E-05 4.31437390586E-05 4.57944079077E-05 4.86073731758E-05 5.15925198336E-05 5.47603300106E-05 5.81219186092E-05 6.16890709983E-05 6.54742829057E-05 6.94908026313E-05 7.37526757126E-05 7.82747921784E-05 8.30729365356E-05 8.81638406407E-05 9.35652396144E-05 9.92959309683E-05 1.05375837118E-04 1.11826071471E-04 1.18669008276E-04 1.25928356445E-04 1.33629237562E-04 1.41798268290E-04 1.50463647429E-04 1.59655247854E-04 1.69404713604E-04 1.79745562377E-04 1.90713293725E-04 2.02345503234E-04 2.14682003001E-04 2.27764948726E-04 2.41638973744E-04 2.56351330367E-04 2.71952038872E-04 2.88494044524E-04 3.06033383027E-04 3.24629354802E-04 3.44344708513E-04 3.65245834283E-04 3.87402967038E-04 4.10890400460E-04 4.35786712016E-04 4.62174999559E-04 4.90143130019E-04 5.19784000689E-04 5.51195813659E-04 5.84482363929E-04 6.19753341765E-04 6.57124649870E-04 6.96718735932E-04 7.38664941146E-04 7.83099865286E-04 8.30167748925E-04 8.80020873380E-04 9.32819978992E-04 9.88734702289E-04 1.04794403263E-03 1.11063678888E-03 1.17701211664E-03 1.24728000658E-03 1.32166183427E-03 1.40039092213E-03 1.48371312373E-03 1.57188743082E-03 1.66518660353E-03 1.76389782375E-03 1.86832337205E-03 1.97878132796E-03 2.09560629380E-03 2.21915014165E-03 2.34978278340E-03 2.48789296321E-03 2.63388907189E-03 2.78819998232E-03 2.95127590498E-03 3.12358926227E-03 3.30563558014E-03 3.49793439524E-03 3.70103017559E-03 3.91549325221E-03 4.14192075905E-03 4.38093757794E-03 4.63319728495E-03 4.89938309411E-03 5.18020879379E-03 5.47641967058E-03 5.78879341494E-03 6.11814100213E-03 6.46530754128E-03 6.83117308485E-03 7.21665338962E-03 7.62270061983E-03 8.05030398201E-03 8.50049028006E-03 8.97432437819E-03 9.47290955835E-03 9.99738775729E-03 1.05489396677E-02 1.11287846865E-02 1.17381806911E-02 1.23784236257E-02 1.30508468745E-02 1.37568204013E-02 1.44977496301E-02 1.52750740427E-02 1.60902654652E-02 1.69448260165E-02 1.78402856877E-02 1.87781995222E-02 1.97601443647E-02 2.07877151427E-02 2.18625206493E-02 2.29861787881E-02 2.41603112452E-02 2.53865375500E-02 2.66664684872E-02 2.80016988217E-02 2.93937992980E-02 3.08443078773E-02 3.23547201754E-02 3.39264790661E-02 3.55609634175E-02 3.72594759305E-02 3.90232300520E-02 4.08533359408E-02 4.27507854666E-02 4.47164362312E-02 4.67509946056E-02 4.88549977857E-02 5.10287948786E-02 5.32725270407E-02 5.55861067020E-02 5.79691959228E-02 6.04211839438E-02 6.29411640070E-02 6.55279095421E-02 6.81798498309E-02 7.08950452854E-02 7.36711624947E-02 7.65054492202E-02 7.93947095450E-02 8.23352794054E-02 8.53230027661E-02 8.83532087199E-02 9.14206898313E-02 9.45196820615E-02 9.76438466516E-02 1.00786254359E-01 1.03939372475E-01 1.07095055079E-01 1.10244536995E-01 1.13378431950E-01 1.16486735451E-01 1.19558832878E-01 1.22583513354E-01 1.25548989878E-01 1.28442926269E-01 1.31252471398E-01 1.33964301190E-01 1.36564668812E-01 1.39039463454E-01 1.41374277991E-01 1.43554485793E-01 1.45565326823E-01 1.47392003070E-01 1.49019783245E-01 1.50434116537E-01 1.51620755062E-01 1.52565884496E-01 1.53256262187E-01 1.53679361871E-01 1.53823523904E-01 1.53678109739E-01 1.53233659149E-01 1.52482048512E-01 1.51416648240E-01 1.50032477276E-01 1.48326352370E-01 1.46297029685E-01 1.43945336160E-01 1.41274287913E-01 1.38289192920E-01 1.34997735137E-01 1.31410037264E-01 1.27538699381E-01 1.23398810821E-01 1.19007932794E-01 1.14386049511E-01 1.09555485864E-01 1.04540790043E-01 9.93685799257E-02 9.40673525287E-02 8.86672563544E-02 8.31998270575E-02 7.76976874825E-02 7.21942137854E-02 6.67231700447E-02 6.13183144515E-02 5.60129808556E-02 5.08396400873E-02 4.58294460726E-02 4.10117722656E-02 3.64137443205E-02 3.20597751763E-02 2.79711087968E-02 2.41653786649E-02 2.06561867358E-02 1.74527078833E-02 1.45593239049E-02 1.19752898774E-02 9.69443408434E-03 7.70489091438E-03 5.98886410941E-03 4.52241565268E-03 3.27527377239E-03 2.23756753955E-03 1.39683176325E-03 7.38191468199E-04 2.44612846991E-04 -1.02777093432E-04 -3.24300676949E-04 -4.41268956014E-04 -4.75450859304E-04 -4.48473674643E-04 -3.81157591371E-04 -2.92788225336E-04 -2.00332336095E-04 -1.17603368831E-04 -5.43850884429E-05 -1.55235267352E-05 1.24588617201E-10 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 3 4 1 i j (l(j)) 4.10577903599E-02 Q_int 1.11343588593E-08 1.18227676553E-08 1.25537357159E-08 1.33298938588E-08 1.41540354981E-08 1.50291266899E-08 1.59583167997E-08 1.69449498279E-08 1.79925764348E-08 1.91049667083E-08 2.02861237205E-08 2.15402979200E-08 2.28720024150E-08 2.42860291977E-08 2.57874663727E-08 2.73817164470E-08 2.90745157508E-08 3.08719550560E-08 3.27805014684E-08 3.48070216702E-08 3.69588065984E-08 3.92435976449E-08 4.16696144746E-08 4.42455845599E-08 4.69807745376E-08 4.98850235007E-08 5.29687783443E-08 5.62431312924E-08 5.97198597396E-08 6.34114685505E-08 6.73312349684E-08 7.14932562937E-08 7.59125005030E-08 8.06048599895E-08 8.55872086175E-08 9.08774622949E-08 9.64946432792E-08 1.02458948449E-07 1.08791821783E-07 1.15516031307E-07 1.22655750781E-07 1.30236646424E-07 1.38285968978E-07 1.46832651448E-07 1.55907412857E-07 1.65542868401E-07 1.75773646380E-07 1.86636512335E-07 1.98170500821E-07 2.10417055304E-07 2.23420176659E-07 2.37226580812E-07 2.51885866085E-07 2.67450690832E-07 2.83976962009E-07 3.01524035342E-07 3.20154927799E-07 3.39936543136E-07 3.60939911303E-07 3.83240442571E-07 4.06918197270E-07 4.32058172109E-07 4.58750604079E-07 4.87091293028E-07 5.17181944040E-07 5.49130530837E-07 5.83051681486E-07 6.19067087780E-07 6.57305939727E-07 6.97905386702E-07 7.41011026868E-07 7.86777426610E-07 8.35368671800E-07 8.86958952844E-07 9.41733185568E-07 9.99887670125E-07 1.06163079024E-06 1.12718375526E-06 1.19678138760E-06 1.27067295831E-06 1.34912307384E-06 1.43241261688E-06 1.52083974476E-06 1.61472094880E-06 1.71439217835E-06 1.82021003344E-06 1.93255303011E-06 2.05182294305E-06 2.17844622990E-06 2.31287554243E-06 2.45559132978E-06 2.60710353914E-06 2.76795342003E-06 2.93871543828E-06 3.11999930622E-06 3.31245213632E-06 3.51676072550E-06 3.73365397807E-06 3.96390547557E-06 4.20833620231E-06 4.46781743609E-06 4.74327381370E-06 5.03568658201E-06 5.34609704540E-06 5.67561022150E-06 6.02539871748E-06 6.39670684021E-06 6.79085495395E-06 7.20924410053E-06 7.65336089740E-06 8.12478273006E-06 8.62518325641E-06 9.15633824117E-06 9.72013174019E-06 1.03185626549E-05 1.09537516788E-05 1.16279486595E-05 1.23435403993E-05 1.31030589217E-05 1.39091902298E-05 1.47647835856E-05 1.56728613409E-05 1.66366293508E-05 1.76594880048E-05 1.87450439104E-05 1.98971222670E-05 2.11197799698E-05 2.24173194854E-05 2.37943035438E-05 2.52555706931E-05 2.68062517656E-05 2.84517873076E-05 3.01979460275E-05 3.20508443191E-05 3.40169669209E-05 3.61031887755E-05 3.83167981550E-05 4.06655211241E-05 4.31575474145E-05 4.58015577885E-05 4.86067529739E-05 5.15828842563E-05 5.47402858190E-05 5.80899089256E-05 6.16433580450E-05 6.54129290224E-05 6.94116494072E-05 7.36533210509E-05 7.81525650965E-05 8.29248694838E-05 8.79866391034E-05 9.33552487354E-05 9.90490989181E-05 1.05087674895E-04 1.11491608796E-04 1.18282745221E-04 1.25484210388E-04 1.33120485023E-04 1.41217481190E-04 1.49802623227E-04 1.58904933010E-04 1.68555119731E-04 1.78785674424E-04 1.89630969431E-04 2.01127363068E-04 2.13313309690E-04 2.26229475432E-04 2.39918859843E-04 2.54426923689E-04 2.69801723172E-04 2.86094050844E-04 3.03357583476E-04 3.21649037168E-04 3.41028329970E-04 3.61558752313E-04 3.83307145519E-04 4.06344088695E-04 4.30744094273E-04 4.56585812516E-04 4.83952245240E-04 5.12930969041E-04 5.43614368314E-04 5.76099878288E-04 6.10490238370E-04 6.46893755989E-04 6.85424581197E-04 7.26202992185E-04 7.69355691914E-04 8.15016115975E-04 8.63324751810E-04 9.14429469330E-04 9.68485862979E-04 1.02565760519E-03 1.08611681117E-03 1.15004441480E-03 1.21763055553E-03 1.28907497584E-03 1.36458742893E-03 1.44438809612E-03 1.52870801336E-03 1.61778950603E-03 1.71188663131E-03 1.81126562687E-03 1.91620536487E-03 2.02699780983E-03 2.14394847873E-03 2.26737690161E-03 2.39761708069E-03 2.53501794562E-03 2.67994380234E-03 2.83277477280E-03 2.99390722223E-03 3.16375417048E-03 3.34274568367E-03 3.53132924170E-03 3.72997007704E-03 3.93915147968E-03 4.15937506252E-03 4.39116098122E-03 4.63504810177E-03 4.89159410866E-03 5.16137554584E-03 5.44498778211E-03 5.74304489185E-03 6.05617944157E-03 6.38504217177E-03 6.73030156322E-03 7.09264327575E-03 7.47276944731E-03 7.87139783981E-03 8.28926081819E-03 8.72710414780E-03 9.18568559493E-03 9.66577331449E-03 1.01681440082E-02 1.06935808363E-02 1.12428710645E-02 1.18168034286E-02 1.24161651985E-02 1.30417389218E-02 1.36942988293E-02 1.43746068831E-02 1.50834084487E-02 1.58214275742E-02 1.65893618568E-02 1.73878768834E-02 1.82176002277E-02 1.90791149916E-02 1.99729528791E-02 2.08995867936E-02 2.18594229527E-02 2.28527925171E-02 2.38799427354E-02 2.49410276094E-02 2.60360980912E-02 2.71650918283E-02 2.83278224787E-02 2.95239686268E-02 3.07530623364E-02 3.20144773885E-02 3.33074172584E-02 3.46309028974E-02 3.59837603967E-02 3.73646086213E-02 3.87718469126E-02 4.02036429755E-02 4.16579210739E-02 4.31323506769E-02 4.46243357092E-02 4.61310045748E-02 4.76492011365E-02 4.91754768491E-02 5.07060842557E-02 5.22369720715E-02 5.37637820882E-02 5.52818481453E-02 5.67861974208E-02 5.82715543003E-02 5.97323470870E-02 6.11627178155E-02 6.25565354276E-02 6.39074125620E-02 6.52087261966E-02 6.64536423635E-02 6.76351451364E-02 6.87460700568E-02 6.97791421327E-02 7.07270184991E-02 7.15823357801E-02 7.23377621345E-02 7.29860539034E-02 7.35201167065E-02 7.39330707530E-02 7.42183200520E-02 7.43696251116E-02 7.43811786247E-02 7.42476835351E-02 7.39644327797E-02 7.35273898957E-02 7.29332695800E-02 7.21796171894E-02 7.12648860729E-02 7.01885115399E-02 6.89509801902E-02 6.75538932630E-02 6.60000226123E-02 6.42933578793E-02 6.24391434147E-02 6.04439035144E-02 5.83154545543E-02 5.60629026701E-02 5.36966257029E-02 5.12282382443E-02 4.86705387437E-02 4.60374378072E-02 4.33438670025E-02 4.06056676951E-02 3.78394596777E-02 3.50624896008E-02 3.22924594798E-02 2.95473358225E-02 2.68451401909E-02 2.42037222744E-02 2.16405167900E-02 1.91722857351E-02 1.68148476837E-02 1.45827959127E-02 1.24892071697E-02 1.05453428078E-02 8.76034381861E-03 7.14092094630E-03 5.69104056958E-03 4.41160636016E-03 3.30013586873E-03 2.35043014922E-03 1.55223332759E-03 8.90877687364E-04 3.46908530198E-04 -8.48708581745E-05 -4.11219727872E-04 -6.40397678163E-04 -7.82063248254E-04 -8.47129014909E-04 -8.47568575759E-04 -7.96170458551E-04 -7.06233576406E-04 -5.91198339398E-04 -4.64206933720E-04 -3.37585602179E-04 -2.22241031601E-04 -1.26962223384E-04 -5.76185692162E-05 -1.62443841724E-05 -1.17391096843E-11 -5.55111512313E-17 0.00000000000E+00 5.55111512313E-17 -5.55111512313E-17 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 4 4 1 i j (l(j)) 1.88062751841E-02 Q_int 5.10340432147E-09 5.41893587834E-09 5.75397454738E-09 6.10972617900E-09 6.48747115139E-09 6.88856897549E-09 7.31446318435E-09 7.76668652459E-09 8.24686646827E-09 8.75673106539E-09 9.29811515763E-09 9.87296697586E-09 1.04833551451E-08 1.11314761219E-08 1.18196620910E-08 1.25503893495E-08 1.33262872089E-08 1.41501474461E-08 1.50249343385E-08 1.59537953184E-08 1.69400722845E-08 1.79873136122E-08 1.90992869053E-08 2.02799925338E-08 2.15336780078E-08 2.28648532385E-08 2.42783067405E-08 2.57791228336E-08 2.73726999065E-08 2.90647698068E-08 3.08614184269E-08 3.27691075604E-08 3.47946981056E-08 3.69454747010E-08 3.92291718791E-08 4.16540018336E-08 4.42286838984E-08 4.69624758436E-08 4.98652071017E-08 5.29473140411E-08 5.62198774139E-08 5.96946621114E-08 6.33841593698E-08 6.73016315759E-08 7.14611598336E-08 7.58776944601E-08 8.05671085928E-08 8.55462550979E-08 9.08330269824E-08 9.64464215264E-08 1.02406608364E-07 1.08735001754E-07 1.15454337299E-07 1.22588753385E-07 1.30163877635E-07 1.38206918675E-07 1.46746763548E-07 1.55814081124E-07 1.65441431856E-07 1.75663384296E-07 1.86516638766E-07 1.98040158630E-07 2.10275309634E-07 2.23266007807E-07 2.37058876438E-07 2.51703412703E-07 2.67252164518E-07 2.83760918239E-07 3.01288897897E-07 3.19898976641E-07 3.39657901158E-07 3.60636529852E-07 3.82910085627E-07 4.06558424161E-07 4.31666318618E-07 4.58323761803E-07 4.86626286812E-07 5.16675307321E-07 5.48578478700E-07 5.82450081209E-07 6.18411426647E-07 6.56591289850E-07 6.97126366564E-07 7.40161759301E-07 7.85851492854E-07 8.34359061294E-07 8.85858008343E-07 9.40532543154E-07 9.98578193629E-07 1.06020249957E-06 1.12562574804E-06 1.19508175352E-06 1.26881868553E-06 1.34709994661E-06 1.43020510368E-06 1.51843087599E-06 1.61209218312E-06 1.71152325651E-06 1.81707881851E-06 1.92913533286E-06 2.04809233100E-06 2.17437381862E-06 2.30842976741E-06 2.45073769697E-06 2.60180435232E-06 2.76216748274E-06 2.93239772797E-06 3.11310061807E-06 3.30491869386E-06 3.50853375495E-06 3.72466924300E-06 3.95409276828E-06 4.19761878777E-06 4.45611144412E-06 4.73048757456E-06 5.02171990006E-06 5.33084040521E-06 5.65894392000E-06 6.00719191536E-06 6.37681652503E-06 6.76912480676E-06 7.18550325702E-06 7.62742259387E-06 8.09644282346E-06 8.59421860669E-06 9.12250494337E-06 9.68316319213E-06 1.02781674453E-05 1.09096112796E-05 1.15797149031E-05 1.22908327222E-05 1.30454613525E-05 1.38462480968E-05 1.46959999201E-05 1.55976929461E-05 1.65544825070E-05 1.75697137761E-05 1.86469330173E-05 1.97898994837E-05 2.10025980030E-05 2.22892522874E-05 2.36543390068E-05 2.51026026683E-05 2.66390713452E-05 2.82690733016E-05 2.99982545620E-05 3.18325974746E-05 3.37784403240E-05 3.58424980464E-05 3.80318841079E-05 4.03541336054E-05 4.28172276549E-05 4.54296191328E-05 4.82002598417E-05 5.11386291710E-05 5.42547643313E-05 5.75592922380E-05 6.10634631305E-05 6.47791860091E-05 6.87190659813E-05 7.28964436088E-05 7.73254363520E-05 8.20209822106E-05 8.69988856643E-05 9.22758660202E-05 9.78696082760E-05 1.03798816613E-04 1.10083270639E-04 1.16743884489E-04 1.23802768932E-04 1.31283296573E-04 1.39210170322E-04 1.47609495224E-04 1.56508853802E-04 1.65937385055E-04 1.75925867227E-04 1.86506804502E-04 1.97714517759E-04 2.09585239523E-04 2.22157213249E-04 2.35470797079E-04 2.49568572201E-04 2.64495455942E-04 2.80298819715E-04 2.97028611950E-04 3.14737486105E-04 3.33480933872E-04 3.53317423663E-04 3.74308544461E-04 3.96519155091E-04 4.20017538972E-04 4.44875564360E-04 4.71168850111E-04 4.98976936916E-04 5.28383463985E-04 5.59476351084E-04 5.92347985809E-04 6.27095415946E-04 6.63820546705E-04 7.02630342583E-04 7.43637033538E-04 7.86958325108E-04 8.32717612043E-04 8.81044194925E-04 9.32073499187E-04 9.85947295859E-04 1.04281392324E-03 1.10282850862E-03 1.16615318907E-03 1.23295733013E-03 1.30341774118E-03 1.37771888607E-03 1.45605308742E-03 1.53862072293E-03 1.62563041171E-03 1.71729918856E-03 1.81385266395E-03 1.91552516702E-03 2.02255986903E-03 2.13520888416E-03 2.25373334429E-03 2.37840344450E-03 2.50949845517E-03 2.64730669679E-03 2.79212547291E-03 2.94426095651E-03 3.10402802484E-03 3.27175003702E-03 3.44775854900E-03 3.63239295940E-03 3.82600008005E-03 4.02893362420E-03 4.24155360536E-03 4.46422563912E-03 4.69732014026E-03 4.94121140686E-03 5.19627658304E-03 5.46289449157E-03 5.74144432760E-03 6.03230420416E-03 6.33584954049E-03 6.65245128385E-03 6.98247395552E-03 7.32627351210E-03 7.68419501303E-03 8.05657008596E-03 8.44371418184E-03 8.84592361231E-03 9.26347236280E-03 9.69660867564E-03 1.01455513986E-02 1.06104860960E-02 1.10915609206E-02 1.15888822470E-02 1.21025100693E-02 1.26324531672E-02 1.31786640499E-02 1.37410336875E-02 1.43193860452E-02 1.49134724382E-02 1.55229657301E-02 1.61474544019E-02 1.67864365235E-02 1.74393136652E-02 1.81053847925E-02 1.87838401934E-02 1.94737554927E-02 2.01740858169E-02 2.08836601776E-02 2.16011761493E-02 2.23251949255E-02 2.30541368421E-02 2.37862774658E-02 2.45197443514E-02 2.52525145784E-02 2.59824131822E-02 2.67071126025E-02 2.74241332747E-02 2.81308454919E-02 2.88244726707E-02 2.95020961515E-02 3.01606616632E-02 3.07969875816E-02 3.14077751015E-02 3.19896204376E-02 3.25390291574E-02 3.30524327366E-02 3.35262074097E-02 3.39566953697E-02 3.43402283469E-02 3.46731535699E-02 3.49518620820E-02 3.51728193509E-02 3.53325980741E-02 3.54279130397E-02 3.54556578605E-02 3.54129433517E-02 3.52971372743E-02 3.51059051171E-02 3.48372515386E-02 3.44895620379E-02 3.40616443751E-02 3.35527692110E-02 3.29627093900E-02 3.22917772467E-02 3.15408592776E-02 3.07114474878E-02 2.98056666920E-02 2.88262970357E-02 2.77767909834E-02 2.66612840256E-02 2.54845983562E-02 2.42522387918E-02 2.29703802276E-02 2.16458459578E-02 2.02860762304E-02 1.88990864554E-02 1.74934145370E-02 1.60780568586E-02 1.46623925046E-02 1.32560953571E-02 1.18690337498E-02 1.05111573964E-02 9.19237132182E-03 7.92239651722E-03 6.71061699058E-03 5.56591279875E-03 4.49647850393E-03 3.50962629115E-03 2.61157269934E-03 1.80720754557E-03 1.09984314767E-03 4.90941364208E-04 -2.01847340389E-05 -4.36698573325E-04 -7.64602120562E-04 -1.01313825520E-03 -1.19524055134E-03 -1.31398799368E-03 -1.37348284751E-03 -1.37884396471E-03 -1.33617552080E-03 -1.25250627222E-03 -1.13569354365E-03 -9.94285115812E-04 -8.37330939549E-04 -6.74135125926E-04 -5.13936928675E-04 -3.65507426641E-04 -2.36646317424E-04 -1.33560651024E-04 -6.01044813897E-05 -1.68553335798E-05 -1.41066491821E-10 -1.11022302463E-16 0.00000000000E+00 1.66533453694E-16 -1.66533453694E-16 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2S 0 2.00 Wavefunction 1.00994387783E-02 1.02533605086E-02 1.04096059503E-02 1.05682101637E-02 1.07292087390E-02 1.08926378052E-02 1.10585340381E-02 1.12269346682E-02 1.13978774897E-02 1.15714008690E-02 1.17475437526E-02 1.19263456772E-02 1.21078467761E-02 1.22920877942E-02 1.24791100870E-02 1.26689556384E-02 1.28616670691E-02 1.30572876437E-02 1.32558612807E-02 1.34574325629E-02 1.36620467474E-02 1.38697497756E-02 1.40805882831E-02 1.42946096108E-02 1.45118618145E-02 1.47323936765E-02 1.49562547157E-02 1.51834951989E-02 1.54141661519E-02 1.56483193706E-02 1.58860074330E-02 1.61272837099E-02 1.63722023776E-02 1.66208184293E-02 1.68731876874E-02 1.71293668158E-02 1.73894133322E-02 1.76533856211E-02 1.79213429465E-02 1.81933454646E-02 1.84694542376E-02 1.87497312466E-02 1.90342394054E-02 1.93230425744E-02 1.96162055744E-02 1.99137942006E-02 2.02158752378E-02 2.05225164739E-02 2.08337867155E-02 2.11497558024E-02 2.14704946231E-02 2.17960751303E-02 2.21265703559E-02 2.24620544278E-02 2.28026025850E-02 2.31482911946E-02 2.34991977676E-02 2.38554009765E-02 2.42169806711E-02 2.45840178967E-02 2.49565949109E-02 2.53347952011E-02 2.57187035029E-02 2.61084058176E-02 2.65039894307E-02 2.69055429307E-02 2.73131562274E-02 2.77269205714E-02 2.81469285730E-02 2.85732742222E-02 2.90060529079E-02 2.94453614385E-02 2.98912980619E-02 3.03439624861E-02 3.08034559002E-02 3.12698809955E-02 3.17433419868E-02 3.22239446341E-02 3.27117962645E-02 3.32070057946E-02 3.37096837530E-02 3.42199423030E-02 3.47378952657E-02 3.52636581435E-02 3.57973481438E-02 3.63390842029E-02 3.68889870100E-02 3.74471790324E-02 3.80137845399E-02 3.85889296299E-02 3.91727422533E-02 3.97653522396E-02 4.03668913236E-02 4.09774931712E-02 4.15972934063E-02 4.22264296378E-02 4.28650414864E-02 4.35132706124E-02 4.41712607435E-02 4.48391577028E-02 4.55171094369E-02 4.62052660447E-02 4.69037798064E-02 4.76128052124E-02 4.83324989929E-02 4.90630201473E-02 4.98045299745E-02 5.05571921026E-02 5.13211725197E-02 5.20966396044E-02 5.28837641566E-02 5.36827194286E-02 5.44936811564E-02 5.53168275914E-02 5.61523395316E-02 5.70004003541E-02 5.78611960465E-02 5.87349152397E-02 5.96217492398E-02 6.05218920610E-02 6.14355404577E-02 6.23628939575E-02 6.33041548943E-02 6.42595284405E-02 6.52292226404E-02 6.62134484433E-02 6.72124197361E-02 6.82263533763E-02 6.92554692253E-02 7.02999901811E-02 7.13601422109E-02 7.24361543844E-02 7.35282589057E-02 7.46366911463E-02 7.57616896770E-02 7.69034963001E-02 7.80623560809E-02 7.92385173794E-02 8.04322318814E-02 8.16437546289E-02 8.28733440510E-02 8.41212619929E-02 8.53877737461E-02 8.66731480765E-02 8.79776572527E-02 8.93015770736E-02 9.06451868949E-02 9.20087696551E-02 9.33926119005E-02 9.47970038091E-02 9.62222392142E-02 9.76686156257E-02 9.91364342514E-02 1.00626000016E-01 1.02137621582E-01 1.03671611360E-01 1.05228285532E-01 1.06807964061E-01 1.08410970700E-01 1.10037633010E-01 1.11688282360E-01 1.13363253936E-01 1.15062886749E-01 1.16787523628E-01 1.18537511227E-01 1.20313200017E-01 1.22114944278E-01 1.23943102097E-01 1.25798035345E-01 1.27680109670E-01 1.29589694474E-01 1.31527162889E-01 1.33492891753E-01 1.35487261575E-01 1.37510656505E-01 1.39563464289E-01 1.41646076228E-01 1.43758887127E-01 1.45902295241E-01 1.48076702212E-01 1.50282513006E-01 1.52520135839E-01 1.54789982098E-01 1.57092466257E-01 1.59428005780E-01 1.61797021028E-01 1.64199935142E-01 1.66637173936E-01 1.69109165766E-01 1.71616341398E-01 1.74159133865E-01 1.76737978315E-01 1.79353311846E-01 1.82005573332E-01 1.84695203238E-01 1.87422643424E-01 1.90188336933E-01 1.92992727769E-01 1.95836260661E-01 1.98719380814E-01 2.01642533642E-01 2.04606164490E-01 2.07610718335E-01 2.10656639475E-01 2.13744371195E-01 2.16874355422E-01 2.20047032356E-01 2.23262840080E-01 2.26522214154E-01 2.29825587183E-01 2.33173388369E-01 2.36566043027E-01 2.40003972094E-01 2.43487591600E-01 2.47017312114E-01 2.50593538171E-01 2.54216667661E-01 2.57887091192E-01 2.61605191428E-01 2.65371342385E-01 2.69185908703E-01 2.73049244879E-01 2.76961694466E-01 2.80923589238E-01 2.84935248313E-01 2.88996977239E-01 2.93109067040E-01 2.97271793221E-01 3.01485414727E-01 3.05750172859E-01 3.10066290147E-01 3.14433969173E-01 3.18853391343E-01 3.23324715616E-01 3.27848077178E-01 3.32423586059E-01 3.37051325708E-01 3.41731351500E-01 3.46463689196E-01 3.51248333339E-01 3.56085245599E-01 3.60974353052E-01 3.65915546399E-01 3.70908678127E-01 3.75953560607E-01 3.81049964123E-01 3.86197614847E-01 3.91396192742E-01 3.96645329402E-01 4.01944605831E-01 4.07293550147E-01 4.12691635236E-01 4.18138276323E-01 4.23632828493E-01 4.29174584138E-01 4.34762770343E-01 4.40396546214E-01 4.46075000135E-01 4.51797146973E-01 4.57561925224E-01 4.63368194098E-01 4.69214730562E-01 4.75100226320E-01 4.81023284764E-01 4.86982417867E-01 4.92976043055E-01 4.99002480039E-01 5.05059947632E-01 5.11146560538E-01 5.17260326143E-01 5.23399141300E-01 5.29560789124E-01 5.35742935808E-01 5.41943127467E-01 5.48158787028E-01 5.54387211172E-01 5.60625567349E-01 5.66870890878E-01 5.73120082149E-01 5.79369903941E-01 5.85616978888E-01 5.91857787091E-01 5.98088663924E-01 6.04305798032E-01 6.10505229562E-01 6.16682848654E-01 6.22834394198E-01 6.28955452915E-01 6.35041458768E-01 6.41087692748E-01 6.47089283058E-01 6.53041205738E-01 6.58938285756E-01 6.64775198601E-01 6.70546472427E-01 6.76246490760E-01 6.81869495829E-01 6.87409592541E-01 6.92860753144E-01 6.98216822611E-01 7.03471524781E-01 7.08618469290E-01 7.13651159322E-01 7.18563000214E-01 7.23347308938E-01 7.27997324479E-01 7.32506219138E-01 7.36867110755E-01 7.41073075885E-01 7.45117163894E-01 7.48992411994E-01 7.52691861177E-01 7.56208573041E-01 7.59535647436E-01 7.62666240899E-01 7.65593585800E-01 7.68311010103E-01 7.70811957640E-01 7.73090008776E-01 7.75138901298E-01 7.76952551379E-01 7.78525074381E-01 7.79850805306E-01 7.80924318604E-01 7.81740447064E-01 7.82294299455E-01 7.82581276558E-01 7.82597085198E-01 7.82337749825E-01 7.81799621185E-01 7.80979381570E-01 7.79874046073E-01 7.78480959291E-01 7.76797786829E-01 7.74822500960E-01 7.72553359741E-01 7.69988878865E-01 7.67127795545E-01 7.63969023647E-01 7.60511599353E-01 7.56754616592E-01 7.52697151537E-01 7.48338175482E-01 7.43676455474E-01 7.38710442140E-01 7.33438144273E-01 7.27856989836E-01 7.21963673214E-01 7.15753988738E-01 7.09222650707E-01 7.02363100419E-01 6.95167301091E-01 6.87645475413E-01 6.79808267388E-01 6.71666722608E-01 6.63232267796E-01 6.54516676288E-01 6.45532055037E-01 6.36290821611E-01 6.26805680531E-01 6.17089599051E-01 6.07155782373E-01 5.97017645934E-01 5.86688768747E-01 5.76177173833E-01 5.65502418336E-01 5.54678541771E-01 5.43719646290E-01 5.32639884072E-01 5.21453413743E-01 5.10174389801E-01 4.98816946687E-01 4.87395162158E-01 4.75923028302E-01 4.64414423660E-01 4.52883085487E-01 4.41342582212E-01 4.29806286189E-01 4.18287346831E-01 4.06798664234E-01 3.95352863414E-01 3.83962269261E-01 3.72638882349E-01 3.61394355737E-01 3.50239972867E-01 3.39186626730E-01 3.28244800380E-01 3.17424548957E-01 3.06735483305E-01 2.96186755284E-01 2.85787044874E-01 2.75544549123E-01 2.65466972992E-01 2.55561522125E-01 2.45834897559E-01 2.36293292349E-01 2.26942390093E-01 2.17787365294E-01 2.08832885503E-01 2.00083115155E-01 1.91541721008E-01 1.83211879075E-01 1.75096282941E-01 1.67197153345E-01 1.59516248902E-01 1.52054877837E-01 1.44813910627E-01 1.37793793411E-01 1.30994562060E-01 1.24415856808E-01 1.18056937330E-01 1.11916698182E-01 1.05993684519E-01 1.00286108011E-01 9.47918629007E-02 8.95085421410E-02 8.44334535663E-02 7.95636360637E-02 7.48958757105E-02 7.04267218557E-02 6.61525031295E-02 6.20693433676E-02 5.81731774441E-02 5.44597670044E-02 5.09247160974E-02 4.75634867007E-02 4.43714141349E-02 4.13437223601E-02 3.84755391451E-02 3.57619110949E-02 3.31978185213E-02 3.07781901317E-02 2.84979175109E-02 2.63518693651E-02 2.43349054900E-02 2.24418904254E-02 2.06677067523E-02 1.90072679873E-02 1.74555310261E-02 1.60075080909E-02 1.46582781313E-02 1.34029976351E-02 1.22369108041E-02 1.11553590551E-02 1.01537898098E-02 9.22776454261E-03 8.37296605985E-03 7.58520499070E-03 6.86042547638E-03 6.19471004997E-03 5.58428370633E-03 5.02551716765E-03 4.51492935686E-03 4.04918909666E-03 3.62511605800E-03 3.23968098680E-03 2.89000524234E-03 2.57335968520E-03 2.28716295574E-03 2.02897918749E-03 1.79651520188E-03 1.58761723252E-03 1.40026722844E-03 1.23257878625E-03 1.08279276097E-03 9.49272605101E-04 8.30499484357E-04 7.25067216895E-04 6.31677081463E-04 5.49132537424E-04 4.76333897376E-04 4.12272990383E-04 3.56027850996E-04 3.06757466295E-04 2.63696610083E-04 2.26150790280E-04 1.93491332400E-04 1.65150618947E-04 1.40617501474E-04 1.19432899143E-04 1.01185594804E-04 8.55082368751E-05 7.20735528602E-05 6.05907779269E-05 5.08022998466E-05 4.24805196212E-05 3.54249253615E-05 2.94593754200E-05 2.44295854228E-05 2.02008126811E-05 1.66557304935E-05 1.36924840612E-05 1.12229191242E-05 9.17097397543E-06 7.47122520781E-06 6.06757738537E-06 4.91208678891E-06 3.96390945744E-06 3.18836391218E-06 2.55609919916E-06 2.04235920554E-06 1.62633457792E-06 1.29059399641E-06 1.02058700751E-06 8.04211099699E-07 6.31436197456E-07 4.93980248385E-07 3.85030076137E-07 2.99002159560E-07 2.31338483527E-07 1.78333062422E-07 1.36980293386E-07 1.04812589333E-07 7.98912681595E-08 6.06689029171E-08 4.59119753422E-08 3.46420714312E-08 2.60874815529E-08 1.96436571877E-08 1.47262586812E-08 1.09904001186E-08 8.16500127532E-09 6.03796948454E-09 4.44413508889E-09 3.25547668619E-09 2.37324065939E-09 1.72161962469E-09 1.24270705325E-09 8.92491051796E-10 6.37689764288E-10 4.53264710737E-10 3.20477220516E-10 2.25377527402E-10 1.57636618172E-10 1.09648071552E-10 7.58413526259E-11 5.21597583882E-11 3.56658180112E-11 2.42447688283E-11 1.63830476691E-11 1.10038103758E-11 7.34553836044E-12 4.87299616489E-12 3.21232574705E-12 2.10403376533E-12 1.36915736788E-12 8.85072503271E-13 5.68310633634E-13 3.62435013405E-13 2.29544691165E-13 1.44361616504E-13 9.01441493491E-14 5.58827704734E-14 3.43894659311E-14 2.10054445332E-14 1.27335166575E-14 7.65993771130E-15 4.57206201349E-15 2.70743366288E-15 1.59041491827E-15 9.26653226193E-16 5.35457136354E-16 3.06816365123E-16 1.74310489021E-16 9.81756374156E-17 5.48103171189E-17 3.03278473881E-17 1.66296450577E-17 9.03497689746E-18 4.86310265230E-18 2.59287087422E-18 1.36920102235E-18 7.15993836292E-19 3.70717434934E-19 1.90021763518E-19 9.64104797742E-20 4.84104003195E-20 2.40535168393E-20 1.18242850644E-20 5.74986269064E-21 2.76538208192E-21 1.31521163361E-21 6.18451447230E-22 2.87481952152E-22 1.32079366279E-22 5.99655815726E-23 2.68988622944E-23 1.19193202641E-23 5.21644358209E-24 2.25435084636E-24 9.61855318976E-25 4.05093507998E-25 1.68373162552E-25 6.90519561542E-26 2.79368092379E-26 1.11477227382E-26 4.38645367816E-27 1.70163767750E-27 6.50659133361E-28 2.45176129182E-28 9.10217011082E-29 3.32855901710E-29 1.19870713672E-29 4.25025418759E-30 1.48340469275E-30 5.09499462504E-31 1.72171787298E-31 5.72278817151E-32 1.87056332222E-32 6.01099291384E-33 1.89852976108E-33 5.89213435084E-34 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2P 1 2.00 Wavefunction 9.69529800746E-05 9.99143734917E-05 1.02965792813E-04 1.06109980732E-04 1.09349763423E-04 1.12688053067E-04 1.16127850474E-04 1.19672247779E-04 1.23324431224E-04 1.27087684023E-04 1.30965389313E-04 1.34961033194E-04 1.39078207868E-04 1.43320614863E-04 1.47692068363E-04 1.52196498634E-04 1.56837955559E-04 1.61620612277E-04 1.66548768931E-04 1.71626856534E-04 1.76859440949E-04 1.82251226991E-04 1.87807062657E-04 1.93531943473E-04 1.99431016990E-04 2.05509587399E-04 2.11773120302E-04 2.18227247611E-04 2.24877772614E-04 2.31730675178E-04 2.38792117120E-04 2.46068447739E-04 2.53566209511E-04 2.61292143965E-04 2.69253197730E-04 2.77456528767E-04 2.85909512794E-04 2.94619749900E-04 3.03595071363E-04 3.12843546673E-04 3.22373490770E-04 3.32193471500E-04 3.42312317292E-04 3.52739125080E-04 3.63483268449E-04 3.74554406042E-04 3.85962490208E-04 3.97717775928E-04 4.09830829993E-04 4.22312540471E-04 4.35174126462E-04 4.48427148134E-04 4.62083517081E-04 4.76155506978E-04 4.90655764569E-04 5.05597320978E-04 5.20993603367E-04 5.36858446944E-04 5.53206107334E-04 5.70051273322E-04 5.87409079982E-04 6.05295122197E-04 6.23725468592E-04 6.42716675884E-04 6.62285803664E-04 6.82450429627E-04 7.03228665253E-04 7.24639171968E-04 7.46701177785E-04 7.69434494453E-04 7.92859535109E-04 8.16997332473E-04 8.41869557583E-04 8.67498539092E-04 8.93907283148E-04 9.21119493866E-04 9.49159594420E-04 9.78052748760E-04 1.00782488398E-03 1.03850271338E-03 1.07011376015E-03 1.10268638188E-03 1.13624979567E-03 1.17083410407E-03 1.20647032181E-03 1.24319040327E-03 1.28102727079E-03 1.32001484383E-03 1.36018806904E-03 1.40158295112E-03 1.44423658472E-03 1.48818718719E-03 1.53347413238E-03 1.58013798536E-03 1.62822053828E-03 1.67776484717E-03 1.72881526992E-03 1.78141750535E-03 1.83561863344E-03 1.89146715675E-03 1.94901304303E-03 2.00830776913E-03 2.06940436622E-03 2.13235746623E-03 2.19722334980E-03 2.26405999553E-03 2.33292713071E-03 2.40388628354E-03 2.47700083687E-03 2.55233608348E-03 2.62995928307E-03 2.70993972073E-03 2.79234876731E-03 2.87725994140E-03 2.96474897316E-03 3.05489387000E-03 3.14777498413E-03 3.24347508208E-03 3.34207941621E-03 3.44367579828E-03 3.54835467513E-03 3.65620920651E-03 3.76733534511E-03 3.88183191899E-03 3.99980071617E-03 4.12134657175E-03 4.24657745747E-03 4.37560457377E-03 4.50854244446E-03 4.64550901402E-03 4.78662574768E-03 4.93201773428E-03 5.08181379190E-03 5.23614657657E-03 5.39515269387E-03 5.55897281369E-03 5.72775178805E-03 5.90163877227E-03 6.08078734930E-03 6.26535565757E-03 6.45550652220E-03 6.65140758980E-03 6.85323146683E-03 7.06115586178E-03 7.27536373097E-03 7.49604342831E-03 7.72338885901E-03 7.95759963728E-03 8.19888124810E-03 8.44744521329E-03 8.70350926178E-03 8.96729750422E-03 9.23904061208E-03 9.51897600127E-03 9.80734802031E-03 1.01044081432E-02 1.04104151673E-02 1.07256354153E-02 1.10503429433E-02 1.13848197525E-02 1.17293560074E-02 1.20842502579E-02 1.24498096670E-02 1.28263502444E-02 1.32141970842E-02 1.36136846094E-02 1.40251568203E-02 1.44489675497E-02 1.48854807230E-02 1.53350706236E-02 1.57981221645E-02 1.62750311652E-02 1.67662046337E-02 1.72720610554E-02 1.77930306860E-02 1.83295558513E-02 1.88820912517E-02 1.94511042727E-02 2.00370753006E-02 2.06404980438E-02 2.12618798591E-02 2.19017420831E-02 2.25606203697E-02 2.32390650309E-02 2.39376413836E-02 2.46569301006E-02 2.53975275660E-02 2.61600462346E-02 2.69451149951E-02 2.77533795374E-02 2.85855027227E-02 2.94421649563E-02 3.03240645637E-02 3.12319181678E-02 3.21664610682E-02 3.31284476218E-02 3.41186516232E-02 3.51378666856E-02 3.61869066204E-02 3.72666058159E-02 3.83778196128E-02 3.95214246776E-02 4.06983193706E-02 4.19094241105E-02 4.31556817308E-02 4.44380578309E-02 4.57575411172E-02 4.71151437352E-02 4.85119015896E-02 4.99488746524E-02 5.14271472557E-02 5.29478283694E-02 5.45120518594E-02 5.61209767276E-02 5.77757873279E-02 5.94776935596E-02 6.12279310326E-02 6.30277612043E-02 6.48784714839E-02 6.67813753023E-02 6.87378121440E-02 7.07491475372E-02 7.28167730011E-02 7.49421059429E-02 7.71265895048E-02 7.93716923539E-02 8.16789084126E-02 8.40497565238E-02 8.64857800475E-02 8.89885463823E-02 9.15596464084E-02 9.42006938445E-02 9.69133245153E-02 9.96991955214E-02 1.02559984307E-01 1.05497387616E-01 1.08513120338E-01 1.11608914221E-01 1.14786516460E-01 1.18047688149E-01 1.21394202578E-01 1.24827843381E-01 1.28350402521E-01 1.31963678096E-01 1.35669471973E-01 1.39469587218E-01 1.43365825337E-01 1.47359983295E-01 1.51453850322E-01 1.55649204481E-01 1.59947808996E-01 1.64351408319E-01 1.68861723942E-01 1.73480449924E-01 1.78209248133E-01 1.83049743184E-01 1.88003517073E-01 1.93072103478E-01 1.98256981739E-01 2.03559570476E-01 2.08981220865E-01 2.14523209541E-01 2.20186731124E-01 2.25972890363E-01 2.31882693881E-01 2.37917041520E-01 2.44076717280E-01 2.50362379841E-01 2.56774552667E-01 2.63313613694E-01 2.69979784592E-01 2.76773119611E-01 2.83693494012E-01 2.90740592089E-01 2.97913894789E-01 3.05212666947E-01 3.12635944150E-01 3.20182519250E-01 3.27850928546E-01 3.35639437671E-01 3.43546027214E-01 3.51568378114E-01 3.59703856872E-01 3.67949500643E-01 3.76302002244E-01 3.84757695169E-01 3.93312538664E-01 4.01962102965E-01 4.10701554763E-01 4.19525643024E-01 4.28428685257E-01 4.37404554356E-01 4.46446666142E-01 4.55547967760E-01 4.64700927069E-01 4.73897523194E-01 4.83129238433E-01 4.92387051678E-01 5.01661433579E-01 5.10942343649E-01 5.20219229532E-01 5.29481028676E-01 5.38716172659E-01 5.47912594403E-01 5.57057738562E-01 5.66138575336E-01 5.75141617985E-01 5.84052944326E-01 5.92858222478E-01 6.01542741122E-01 6.10091444551E-01 6.18488972742E-01 6.26719706689E-01 6.34767819213E-01 6.42617331411E-01 6.50252174902E-01 6.57656259954E-01 6.64813549554E-01 6.71708139383E-01 6.78324343613E-01 6.84646786353E-01 6.90660498464E-01 6.96351019362E-01 7.01704503299E-01 7.06707829488E-01 7.11348715255E-01 7.15615831274E-01 7.19498917730E-01 7.22988900049E-01 7.26078002670E-01 7.28759859036E-01 7.31029615811E-01 7.32884029031E-01 7.34321549678E-01 7.35342395860E-01 7.35948608561E-01 7.36144087631E-01 7.35934604454E-01 7.35327787511E-01 7.34333076801E-01 7.32961642969E-01 7.31226266826E-01 7.29141174888E-01 7.26721826567E-01 7.23984648716E-01 7.20946713470E-01 7.17625355583E-01 7.14037725971E-01 7.10200278749E-01 7.06128189902E-01 7.01834706676E-01 6.97330428107E-01 6.92622518469E-01 6.87713857144E-01 6.82602130557E-01 6.77278873965E-01 6.71748111431E-01 6.66014086545E-01 6.60081257560E-01 6.53954292154E-01 6.47638061956E-01 6.41137636783E-01 6.34458276030E-01 6.27605400086E-01 6.20584608725E-01 6.13401729542E-01 6.06062763526E-01 5.98573850799E-01 5.90944077717E-01 5.83177095325E-01 5.75279443114E-01 5.67257795658E-01 5.59118943277E-01 5.50869780672E-01 5.42517296212E-01 5.34068560719E-01 5.25530715717E-01 5.16910961185E-01 5.08216542812E-01 4.99454738814E-01 4.90632846353E-01 4.81758167631E-01 4.72837995729E-01 4.63879600290E-01 4.54890213146E-01 4.45877014008E-01 4.36847116315E-01 4.27807553401E-01 4.18765265071E-01 4.09727084733E-01 4.00699727187E-01 3.91689777196E-01 3.82703678928E-01 3.73747726356E-01 3.64828054700E-01 3.55950632938E-01 3.47121257450E-01 3.38345546794E-01 3.29628937607E-01 3.20976681629E-01 3.12393843791E-01 3.03885301317E-01 2.95455743769E-01 2.87109673956E-01 2.78851409596E-01 2.70685085642E-01 2.62614657151E-01 2.54643902582E-01 2.46776427404E-01 2.39015667902E-01 2.31364895054E-01 2.23827218379E-01 2.16405589642E-01 2.09102806328E-01 2.01921514792E-01 1.94864213004E-01 1.87933252845E-01 1.81130841879E-01 1.74459044594E-01 1.67919783062E-01 1.61514837043E-01 1.55245843525E-01 1.49114295735E-01 1.43121541660E-01 1.37268782131E-01 1.31557068548E-01 1.25987300303E-01 1.20560222012E-01 1.15276420634E-01 1.10136322578E-01 1.05140190907E-01 1.00288122728E-01 9.55800468718E-02 9.10157219627E-02 8.65947349493E-02 8.23165001903E-02 7.81802591560E-02 7.41850808044E-02 7.03298626781E-02 6.66133327553E-02 6.30340520738E-02 5.95904181381E-02 5.62806691029E-02 5.31028887195E-02 5.00550120164E-02 4.71348316795E-02 4.43400050864E-02 4.16680619424E-02 3.91164124600E-02 3.66823560195E-02 3.43630902416E-02 3.21557204050E-02 3.00572691362E-02 2.80646863016E-02 2.61748590294E-02 2.43846217940E-02 2.26907664942E-02 2.10900524610E-02 1.95792163348E-02 1.81549817526E-02 1.68140687945E-02 1.55532031382E-02 1.43691248785E-02 1.32585969726E-02 1.22184132748E-02 1.12454061321E-02 1.03364535145E-02 9.48848566037E-03 8.69849121935E-03 7.96352288267E-03 7.28070249236E-03 6.64722562643E-03 6.06036566005E-03 5.51747730685E-03 5.01599964719E-03 4.55345865388E-03 4.12746922808E-03 3.73573676097E-03 3.37605823879E-03 3.04632291088E-03 2.74451254218E-03 2.46870127280E-03 2.21705510873E-03 1.98783106856E-03 1.77937601178E-03 1.59012517471E-03 1.41860044044E-03 1.26340836906E-03 1.12323801449E-03 9.96858553677E-04 8.83116753692E-04 7.80934301439E-04 6.89305019943E-04 6.07291994348E-04 5.34024629686E-04 4.68695661419E-04 4.10558138555E-04 3.58922397921E-04 3.13153046889E-04 2.72665970514E-04 2.36925377775E-04 2.05440899999E-04 1.77764753736E-04 1.53488978511E-04 1.32242758843E-04 1.13689838650E-04 9.75260349815E-05 8.34768569826E-05 7.12952344245E-05 6.07593604397E-05 5.16706510285E-05 4.38502639032E-05 3.71248655309E-05 3.13546587724E-05 2.64170566897E-05 2.22034449710E-05 1.86178702284E-05 1.55758243621E-05 1.30031231652E-05 1.08348772207E-05 9.01455316604E-06 7.49312360115E-06 6.22830431117E-06 5.16197569070E-06 4.26562042519E-06 3.51438397435E-06 2.88667106903E-06 2.36377707667E-06 1.92955250128E-06 1.57009880166E-06 1.27349365715E-06 1.02954378098E-06 8.29563374767E-07 6.66176332739E-07 5.33140336732E-07 4.25191031786E-07 3.37904534305E-07 2.67576597789E-07 2.11116843131E-07 1.65956549028E-07 1.29968591289E-07 1.01398215946E-07 7.88034283001E-08 6.10038771147E-08 4.70372086239E-08 3.61219579480E-08 2.76261349096E-08 2.10407464539E-08 1.59575783420E-08 1.20506341106E-08 9.06069923677E-09 6.78256288009E-09 5.05448848684E-09 3.74957801097E-09 2.76872269102E-09 2.03487644250E-09 1.48842624973E-09 1.08346777472E-09 7.84824071678E-10 5.65671145291E-10 4.05656464845E-10 2.89415786736E-10 2.05410076890E-10 1.45018280191E-10 1.01833455139E-10 7.11196570314E-11 4.93951674522E-11 3.41144640232E-11 2.34269107661E-11 1.59947116787E-11 1.08563717274E-11 7.32489312633E-12 4.91232390182E-12 3.27417613298E-12 2.16873279881E-12 1.42744057436E-12 9.33504472272E-13 6.06511320894E-13 3.91455764032E-13 2.50959838352E-13 1.59793583533E-13 1.01042289825E-13 6.34439529689E-14 3.95525321072E-14 2.44798326222E-14 1.50399043868E-14 9.17140453881E-15 5.55049482817E-15 3.33336464606E-15 1.98627171453E-15 1.17421568674E-15 6.88586311918E-16 4.00513623884E-16 2.31031350778E-16 1.32149267294E-16 7.49451442652E-17 4.21357746205E-17 2.34817360534E-17 1.29695017732E-17 7.09858054176E-18 3.84959674237E-18 2.06820667429E-18 1.10064220440E-18 5.80108923082E-19 3.02775529216E-19 1.56464410753E-19 8.00439835360E-20 4.05316159039E-20 2.03115942716E-20 1.00718843831E-20 4.94111314351E-21 2.39781619915E-21 1.15083382815E-21 5.46188462279E-22 2.56290222178E-22 1.18879369989E-22 5.44991957756E-23 2.46891357923E-23 1.10503433094E-23 4.88562863351E-24 2.13333690335E-24 9.19837368529E-25 3.91554593289E-25 1.64520142592E-25 6.82190784172E-26 2.79103884381E-26 1.12644789818E-26 6.04554821665E-06 6.29312589659E-06 6.54922871288E-06 6.81413506414E-06 7.08813255344E-06 7.37151830922E-06 7.66459933670E-06 7.96769286267E-06 8.28112670013E-06 8.60523962704E-06 8.94038177954E-06 9.28691507419E-06 9.64521354702E-06 1.00156640739E-05 1.03986663145E-05 1.07946336235E-05 1.12039935155E-05 1.16271880083E-05 1.20646742161E-05 1.25169249132E-05 1.29844291105E-05 1.34676926533E-05 1.39672388471E-05 1.44836091042E-05 1.50173636201E-05 1.55690820744E-05 1.61393643632E-05 1.67288313582E-05 1.73381257016E-05 1.79679126295E-05 1.86188808332E-05 1.92917433547E-05 1.99872385213E-05 2.07061309195E-05 2.14492124109E-05 2.22173031902E-05 2.30112528927E-05 2.38319417448E-05 2.46802817733E-05 2.55572180530E-05 2.64637300293E-05 2.74008328810E-05 2.83695789568E-05 2.93710592662E-05 3.04064050531E-05 3.14767894133E-05 3.25834290243E-05 3.37275859109E-05 3.49105693239E-05 3.61337376986E-05 3.73985006873E-05 3.87063213018E-05 4.00587181601E-05 4.14572678215E-05 4.29036072399E-05 4.43994363377E-05 4.59465206880E-05 4.75466943402E-05 4.92018627679E-05 5.09140059672E-05 5.26851816915E-05 5.45175288588E-05 5.64132711124E-05 5.83747205642E-05 6.04042817095E-05 6.25044555496E-05 6.46778439060E-05 6.69271539599E-05 6.92552030077E-05 7.16649234658E-05 7.41593681206E-05 7.67417156490E-05 7.94152764182E-05 8.21834985852E-05 8.50499745056E-05 8.80184474777E-05 9.10928188340E-05 9.42771554017E-05 9.75756973571E-05 1.00992866487E-04 1.04533274891E-04 1.08201734138E-04 1.12003264916E-04 1.15943107188E-04 1.20026730900E-04 1.24259847252E-04 1.28648420586E-04 1.33198680906E-04 1.37917137082E-04 1.42810590768E-04 1.47886151075E-04 1.53151250047E-04 1.58613658983E-04 1.64281505651E-04 1.70163292450E-04 1.76267915574E-04 1.82604685227E-04 1.89183346962E-04 1.96014104204E-04 2.03107642014E-04 2.10475152192E-04 2.18128359759E-04 2.26079550938E-04 2.34341602687E-04 2.42928013895E-04 2.51852938322E-04 2.61131219403E-04 2.70778427002E-04 2.80810896237E-04 2.91245768530E-04 3.02101034916E-04 3.13395581863E-04 3.25149239681E-04 3.37382833660E-04 3.50118238098E-04 3.63378433491E-04 3.77187566873E-04 3.91571015660E-04 4.06555455148E-04 4.22168929818E-04 4.38440928720E-04 4.55402465305E-04 4.73086161580E-04 4.91526337345E-04 5.10759104348E-04 5.30822465997E-04 5.51756422654E-04 5.73603083093E-04 5.96406782294E-04 6.20214206042E-04 6.45074522637E-04 6.71039522256E-04 6.98163764248E-04 7.26504732954E-04 7.56123002466E-04 7.87082410858E-04 8.19450244431E-04 8.53297432572E-04 8.88698753776E-04 9.25733053532E-04 9.64483474718E-04 1.00503770120E-03 1.04748821544E-03 1.09193257084E-03 1.13847367970E-03 1.18722011771E-03 1.23828644579E-03 1.29179355037E-03 1.34786900308E-03 1.40664744099E-03 1.46827096852E-03 1.53288958215E-03 1.60066161936E-03 1.67175423303E-03 1.74634389268E-03 1.82461691417E-03 1.90677001921E-03 1.99301092656E-03 2.08355897642E-03 2.17864578992E-03 2.27851596560E-03 2.38342781493E-03 2.49365413874E-03 2.60948304703E-03 2.73121882432E-03 2.85918284281E-03 2.99371452619E-03 3.13517236643E-03 3.28393499644E-03 3.44040232153E-03 3.60499671254E-03 3.77816426391E-03 3.96037611990E-03 4.15212987243E-03 4.35395103403E-03 4.56639458969E-03 4.79004663138E-03 5.02552607940E-03 5.27348649452E-03 5.53461798536E-03 5.80964921552E-03 6.09934951491E-03 6.40453110032E-03 6.72605140987E-03 7.06481555680E-03 7.42177890741E-03 7.79794978897E-03 8.19439233282E-03 8.61222945841E-03 9.05264600414E-03 9.51689201081E-03 1.00062861637E-02 1.05222193993E-02 1.10661586830E-02 1.16396509640E-02 1.22443273127E-02 1.28819072489E-02 1.35542032647E-02 1.42631255492E-02 1.50106869218E-02 1.57990079788E-02 1.66303224588E-02 1.75069828343E-02 1.84314661319E-02 1.94063799883E-02 2.04344689447E-02 2.15186209847E-02 2.26618743176E-02 2.38674244109E-02 2.51386312730E-02 2.64790269864E-02 2.78923234927E-02 2.93824206263E-02 3.09534143946E-02 3.26096055011E-02 3.43555081047E-02 3.61958588078E-02 3.81356258632E-02 4.01800185886E-02 4.23344969728E-02 4.46047814582E-02 4.69968628782E-02 4.95170125263E-02 5.21717923306E-02 5.49680651028E-02 5.79130048263E-02 6.10141069449E-02 6.42791986074E-02 6.77164488190E-02 7.13343784447E-02 7.51418700031E-02 7.91481771846E-02 8.33629340191E-02 8.77961636118E-02 9.24582863593E-02 9.73601275481E-02 1.02512924231E-01 1.07928331267E-01 1.13618426401E-01 1.19595714249E-01 1.25873129052E-01 1.32464036037E-01 1.39382231222E-01 1.46641939502E-01 1.54257810815E-01 1.62244914200E-01 1.70618729539E-01 1.79395136761E-01 1.88590402284E-01 1.98221162451E-01 2.08304403710E-01 2.18857439289E-01 2.29897882084E-01 2.41443613501E-01 2.53512747967E-01 2.66123592822E-01 2.79294603316E-01 2.93044332425E-01 3.07391375195E-01 3.22354307354E-01 3.37951617909E-01 3.54201635498E-01 3.71122448240E-01 3.88731816889E-01 4.07047081105E-01 4.26085058689E-01 4.45861937680E-01 4.66393161265E-01 4.87693305468E-01 5.09775949719E-01 5.32653540397E-01 5.56337247588E-01 5.80836815347E-01 6.06160405872E-01 6.32314438105E-01 6.59303421398E-01 6.87129784997E-01 7.15793704272E-01 7.45292924724E-01 7.75622584996E-01 8.06775040266E-01 8.38739687567E-01 8.71502794776E-01 9.05047335154E-01 9.39352829555E-01 9.74395198541E-01 1.01014662684E+00 1.04657544274E+00 1.08364601517E+00 1.12131867123E+00 1.15954963724E+00 1.19829100622E+00 1.23749073480E+00 1.27709267266E+00 1.31703662718E+00 1.35725846625E+00 1.39769026162E+00 1.43826047496E+00 1.47889418839E+00 1.51951338087E+00 1.56003725087E+00 1.60038258547E+00 1.64046417474E+00 1.68019526969E+00 1.71948808080E+00 1.75825431286E+00 1.79640573092E+00 1.83385475049E+00 1.87051504370E+00 1.90630215204E+00 1.94113409432E+00 1.97493195745E+00 2.00762045616E+00 2.03912844645E+00 2.06938937663E+00 2.09834165893E+00 2.12592894410E+00 2.15210028114E+00 2.17681014469E+00 2.20001831312E+00 2.22168958148E+00 2.24179329532E+00 2.26030269364E+00 2.27719405193E+00 2.29244562026E+00 2.30603635506E+00 2.31794444832E+00 2.32814566372E+00 2.33661149474E+00 2.34330716758E+00 2.34818951864E+00 2.35120478519E+00 2.35228635704E+00 2.35135254679E+00 2.34837541481E+00 2.34332661590E+00 2.33617705428E+00 2.32689645024E+00 2.31550662445E+00 2.30203517604E+00 2.28651536856E+00 2.26898599095E+00 2.24949119404E+00 2.22808030348E+00 2.20480761048E+00 2.17973214137E+00 2.15291740771E+00 2.12443113818E+00 2.09434499403E+00 2.06273426969E+00 2.02967758038E+00 1.99525653860E+00 1.95955544288E+00 1.92266091792E+00 1.88466156771E+00 1.84564762450E+00 1.80571055612E+00 1.76494274141E+00 1.72343711810E+00 1.68128683386E+00 1.63858490239E+00 1.59542386601E+00 1.55189545394E+00 1.50809015648E+00 1.46408195714E+00 1.41997389374E+00 1.37585162524E+00 1.33179844277E+00 1.28790114154E+00 1.24423150507E+00 1.20086444550E+00 1.15787175348E+00 1.11532187612E+00 1.07327975282E+00 1.03180667612E+00 9.90960173096E-01 9.50793907329E-01 9.11357601636E-01 8.72696981559E-01 8.34853739555E-01 7.97865519685E-01 7.61765922501E-01 7.26584529686E-01 6.92346947905E-01 6.59074871167E-01 6.26786160910E-01 5.95494942844E-01 5.65211719498E-01 5.35943497298E-01 5.07693926866E-01 4.80463455166E-01 4.54249488022E-01 4.29046561463E-01 4.04846520336E-01 3.81638702546E-01 3.59410127343E-01 3.38145686047E-01 3.17828333656E-01 2.98439279859E-01 2.79958178020E-01 2.62363310825E-01 2.45631771381E-01 2.29739638672E-01 2.14662146409E-01 2.00373844447E-01 1.86848752082E-01 1.74060502660E-01 1.61982479087E-01 1.50587939931E-01 1.39850135966E-01 1.29742417078E-01 1.20238329588E-01 1.11311704140E-01 1.02936734368E-01 9.50880466468E-02 8.77407612796E-02 8.08705455384E-02 7.44536590007E-02 6.84669916637E-02 6.28880953336E-02 5.76952087985E-02 5.28672772977E-02 4.83839667930E-02 4.42256735380E-02 4.03735294242E-02 3.68094035604E-02 3.35159005180E-02 3.04763556440E-02 2.76748278181E-02 2.50960899927E-02 2.27256178292E-02 2.05495767090E-02 1.85548073678E-02 1.67288103755E-02 1.50597296536E-02 1.35363351999E-02 1.21480051671E-02 1.08847074230E-02 9.73698070139E-03 8.69591543948E-03 7.75313438510E-03 6.90077304612E-03 6.13146004729E-03 5.43829745270E-03 4.81484110729E-03 4.25508104702E-03 3.75342202436E-03 3.30466419385E-03 2.90398400064E-03 2.54691531357E-03 2.22933084321E-03 1.94742388412E-03 1.69769041906E-03 1.47691162159E-03 1.28213679161E-03 1.11066675652E-03 9.60037768132E-04 8.28005923163E-04 7.12532132104E-04 6.11767658206E-04 5.24040245074E-04 4.47840847915E-04 3.81810979932E-04 3.24730681768E-04 2.75507118310E-04 2.33163803620E-04 1.96830451285E-04 1.65733444166E-04 1.39186914397E-04 1.16584421539E-04 9.73912141063E-05 8.11370572725E-05 6.74096074121E-05 5.58483122876E-05 4.61388141573E-05 3.80078318295E-05 3.12184967519E-05 2.55661175691E-05 2.08743472081E-05 1.69917264378E-05 1.37885779760E-05 1.11542255662E-05 8.99451299512E-06 7.22959873815E-06 5.79200279162E-06 4.62488324051E-06 3.68052120214E-06 2.91899395326E-06 2.30701726831E-06 1.81693924952E-06 1.42586919640E-06 1.11492632522E-06 8.68594394088E-07 6.74169502106E-07 5.21289502071E-07 4.01534585481E-07 3.08089659662E-07 2.35460134425E-07 1.79233666277E-07 1.35881270002E-07 1.02591999675E-07 7.71361243667E-08 5.77523802088E-08 4.30554709943E-08 3.19605187618E-08 2.36216363515E-08 1.73822098766E-08 1.27348445248E-08 9.28924604094E-09 6.74658766990E-09 4.87915079808E-09 3.51398274562E-09 2.51874387609E-09 1.79662559300E-09 1.27532718673E-09 9.00933930007E-10 6.33449172188E-10 4.43356929094E-10 3.08991466426E-10 2.14535360801E-10 1.48504327318E-10 1.02606844108E-10 7.08908281874E-11 4.86947571640E-11 3.32517588767E-11 2.25708834892E-11 1.52280636656E-11 1.02108777058E-11 6.80398279979E-12 4.50509491255E-12 2.96376341269E-12 1.93704443280E-12 1.25761894368E-12 8.11013942390E-13 5.19437139116E-13 3.30383309892E-13 2.08659394656E-13 1.30841693172E-13 8.14508581937E-14 5.03313624810E-14 3.08692955154E-14 1.87892965790E-14 1.13485432308E-14 6.80087460953E-15 4.04327214840E-15 2.38447326366E-15 1.39473001839E-15 8.09044067167E-16 4.65354439816E-16 2.65380917863E-16 1.50028345617E-16 8.40693227009E-17 4.66878972430E-17 2.56929918033E-17 1.40090540531E-17 7.56703911884E-18 4.04859684376E-18 2.14526964926E-18 1.12562704983E-18 5.84760384745E-19 3.00723033933E-19 1.53071495309E-19 7.71069245349E-20 3.84322129248E-20 1.89509440610E-20 9.24334574997E-21 4.45880844605E-21 2.12680168556E-21 1.00295151247E-21 4.67522721971E-22 2.15386907980E-22 9.80511013110E-23 4.40985064634E-23 1.95908810541E-23 8.59531873775E-24 3.72362524018E-24 1.59251193884E-24 6.72245206753E-25 2.80036909129E-25 1.15095499731E-25 4.66625602534E-26 1.86576202915E-26 7.35580757988E-27 2.85889677346E-27 1.09513278116E-27 4.13371034440E-28 1.53716890655E-28 5.63006353224E-29 2.03055866342E-29 7.20986623280E-30 2.51968149783E-30 8.66496198376E-31 2.93146341361E-31 9.75420156179E-32 3.19138654744E-32 1.02644785353E-32 3.24453046016E-33 1.00765135938E-33 3.07394771832E-34 9.20858538922E-35 2.70819771490E-35 7.81695769558E-36 2.21381953228E-36 6.14991314729E-37 1.67529554964E-37 4.47384598152E-38 1.17086622632E-38 3.00218691575E-39 7.53941964150E-40 1.85383618369E-40 4.46169098891E-41 1.05070710922E-41 2.42033304073E-42 5.45173747744E-43 1.20036677526E-43 2.58263409839E-44 5.42787800701E-45 1.11393966291E-45 2.23152333487E-46 4.36205156911E-47 8.31703986383E-48 1.54622250036E-48 2.80178326556E-49 4.94638646944E-50 8.50475069360E-51 1.42357926109E-51 2.31884707834E-52 TDDFPT/Examples/pseudo/C.pz-vbc.UPF0000644000175000017500000010775212341371476015162 0ustar mbamba Generated using ld1 code Author: P. Giannozzi Generation date: 1990 Info: C LDA 2s2 2p2 VonBarth-Car, l=1 local 0 The Pseudo was generated with a Non-Relativistic Calculation 0.00000000000E+00 Local Potential cutoff radius nl pn l occ Rcut Rcut US E pseu 2S 0 0 2.00 0.00000000000 0.00000000000 0.00000000000 2P 0 1 2.00 0.00000000000 0.00000000000 0.00000000000 0 Version Number C Element NC Norm - Conserving pseudopotential F Nonlinear Core Correction SLA PZ NOGX NOGC PZ Exchange-Correlation functional 4.00000000000 Z valence 0.00000000000 Total energy 0.0000000 0.0000000 Suggested cutoff for wfc and rho 0 Max angular momentum component 269 Number of points in mesh 2 1 Number of Wavefunctions, Number of Projectors Wavefunctions nl l occ 2S 0 2.00 2P 1 2.00 5.61495583257E-04 5.87340023303E-04 6.14374027614E-04 6.42652349289E-04 6.72232261592E-04 7.03173673954E-04 7.35539253311E-04 7.69394551019E-04 8.04808135628E-04 8.41851731748E-04 8.80600365321E-04 9.21132515572E-04 9.63530273956E-04 1.00787951042E-03 1.05427004733E-03 1.10279584138E-03 1.15355517387E-03 1.20665084981E-03 1.26219040609E-03 1.32028632928E-03 1.38105628348E-03 1.44462334862E-03 1.51111626973E-03 1.58066971770E-03 1.65342456203E-03 1.72952815614E-03 1.80913463582E-03 1.89240523139E-03 1.97950859428E-03 2.07062113854E-03 2.16592739823E-03 2.26562040109E-03 2.36990205952E-03 2.47898357951E-03 2.59308588842E-03 2.71244008243E-03 2.83728789455E-03 2.96788218428E-03 3.10448744968E-03 3.24738036311E-03 3.39685033153E-03 3.55320008272E-03 3.71674627836E-03 3.88782015537E-03 4.06676819683E-03 4.25395283368E-03 4.44975317877E-03 4.65456579471E-03 4.86880549704E-03 5.09290619438E-03 5.32732176723E-03 5.57252698722E-03 5.82901847872E-03 6.09731572467E-03 6.37796211866E-03 6.67152606556E-03 6.97860213268E-03 7.29981225400E-03 7.63580698979E-03 7.98726684421E-03 8.35490364357E-03 8.73946197802E-03 9.14172070963E-03 9.56249454977E-03 1.00026357093E-02 1.04630356244E-02 1.09446267624E-02 1.14483845097E-02 1.19753291481E-02 1.25265279205E-02 1.31030971928E-02 1.37062047148E-02 1.43370719853E-02 1.49969767261E-02 1.56872554699E-02 1.64093062670E-02 1.71645915171E-02 1.79546409308E-02 1.87810546283E-02 1.96455063797E-02 2.05497469951E-02 2.14956078710E-02 2.24850046987E-02 2.35199413450E-02 2.46025139103E-02 2.57349149740E-02 2.69194380352E-02 2.81584821579E-02 2.94545568299E-02 3.08102870453E-02 3.22284186212E-02 3.37118237586E-02 3.52635068598E-02 3.68866106134E-02 3.85844223593E-02 4.03603807463E-02 4.22180826971E-02 4.41612906931E-02 4.61939403945E-02 4.83201486117E-02 5.05442216427E-02 5.28706639957E-02 5.53041875114E-02 5.78497209065E-02 6.05124197561E-02 6.32976769354E-02 6.62111335419E-02 6.92586903210E-02 7.24465196166E-02 7.57810778724E-02 7.92691187084E-02 8.29177065994E-02 8.67342311827E-02 9.07264222249E-02 9.49023652771E-02 9.92705180510E-02 1.03839727549E-01 1.08619247982E-01 1.13618759511E-01 1.18848387857E-01 1.24318724803E-01 1.30040849653E-01 1.36026351663E-01 1.42287353521E-01 1.48836535896E-01 1.55687163119E-01 1.62853110053E-01 1.70348890188E-01 1.78189685041E-01 1.86391374902E-01 1.94970570994E-01 2.03944649122E-01 2.13331784861E-01 2.23150990368E-01 2.33422152892E-01 2.44166075044E-01 2.55404516941E-01 2.67160240267E-01 2.79457054379E-01 2.92319864529E-01 3.05774722302E-01 3.19848878383E-01 3.34570837750E-01 3.49970417399E-01 3.66078806743E-01 3.82928630776E-01 4.00554016148E-01 4.18990660289E-01 4.38275903704E-01 4.58448805601E-01 4.79550223000E-01 5.01622893484E-01 5.24711521752E-01 5.48862870168E-01 5.74125853465E-01 6.00551637818E-01 6.28193744472E-01 6.57108158138E-01 6.87353440386E-01 7.18990848247E-01 7.52084458286E-01 7.86701296372E-01 8.22911473431E-01 8.60788327447E-01 9.00408571994E-01 9.41852451607E-01 9.85203904304E-01 1.03055073159E+00 1.07798477630E+00 1.12760210856E+00 1.17950322045E+00 1.23379322944E+00 1.29058209136E+00 1.34998482306E+00 1.41212173538E+00 1.47711867679E+00 1.54510728831E+00 1.61622527012E+00 1.69061666044E+00 1.76843212724E+00 1.84982927345E+00 1.93497295611E+00 2.02403562026E+00 2.11719764824E+00 2.21464772499E+00 2.31658322022E+00 2.42321058815E+00 2.53474578563E+00 2.65141470956E+00 2.77345365437E+00 2.90110979063E+00 3.03464166566E+00 3.17431972712E+00 3.32042687082E+00 3.47325901367E+00 3.63312569298E+00 3.80035069340E+00 3.97527270272E+00 4.15824599778E+00 4.34964116204E+00 4.54984583610E+00 4.75926550285E+00 4.97832430868E+00 5.20746592254E+00 5.44715443450E+00 5.69787529571E+00 5.96013630160E+00 6.23446862033E+00 6.52142786859E+00 6.82159523693E+00 7.13557866685E+00 7.46401408210E+00 7.80756667662E+00 8.16693226184E+00 8.54283867587E+00 8.93604725767E+00 9.34735438898E+00 9.77759310732E+00 1.02276347931E+01 1.06983909346E+01 1.11908149737E+01 1.17059042376E+01 1.22447019580E+01 1.28082993843E+01 1.33978379941E+01 1.40145118043E+01 1.46595697903E+01 1.53343184150E+01 1.60401242748E+01 1.67784168678E+01 1.75506914889E+01 1.83585122580E+01 1.92035152884E+01 2.00874119998E+01 2.10119925853E+01 2.19791296364E+01 2.29907819362E+01 2.40489984264E+01 2.51559223569E+01 2.63137956270E+01 2.75249633258E+01 2.87918784818E+01 3.01171070310E+01 3.15033330143E+01 3.29533640129E+01 3.44701368353E+01 3.60567234645E+01 3.77163372809E+01 3.94523395696E+01 4.12682463283E+01 4.31677353890E+01 4.51546538661E+01 4.72330259485E+01 4.94070610499E+01 5.16811623344E+01 5.40599356342E+01 5.65481987783E+01 5.91509913497E+01 6.18735848931E+01 6.47214935906E+01 6.77004854306E+01 7.08165938898E+01 7.40761301526E+01 7.74856958938E+01 8.10521966493E+01 8.47828558020E+01 8.86852292115E+01 9.27672205176E+01 9.70370971477E+01 2.52673012466E-05 2.64303010486E-05 2.76468312426E-05 2.89193557180E-05 3.02504517716E-05 3.16428153279E-05 3.30992663990E-05 3.46227547959E-05 3.62163661033E-05 3.78833279287E-05 3.96270164394E-05 4.14509632007E-05 4.33588623280E-05 4.53545779690E-05 4.74421521300E-05 4.96258128620E-05 5.19099828243E-05 5.42992882416E-05 5.67985682739E-05 5.94128848175E-05 6.21475327566E-05 6.50080506880E-05 6.80002321380E-05 7.11301372966E-05 7.44041052914E-05 7.78287670264E-05 8.14110586119E-05 8.51582354127E-05 8.90778867424E-05 9.31779512343E-05 9.74667329203E-05 1.01952918049E-04 1.06645592678E-04 1.11554261078E-04 1.16688864979E-04 1.22059803709E-04 1.27677955255E-04 1.33554698293E-04 1.39701935236E-04 1.46132116340E-04 1.52858264919E-04 1.59894003722E-04 1.67253582526E-04 1.74951906992E-04 1.83004568858E-04 1.91427877516E-04 2.00238893044E-04 2.09455460762E-04 2.19096247367E-04 2.29180778747E-04 2.39729479525E-04 2.50763714425E-04 2.62305831542E-04 2.74379207610E-04 2.87008295340E-04 3.00218672950E-04 3.14037095971E-04 3.28491551430E-04 3.43611314541E-04 3.59427007989E-04 3.75970663961E-04 3.93275789011E-04 4.11377431933E-04 4.30312254740E-04 4.50118606918E-04 4.70836603099E-04 4.92508204307E-04 5.15177302939E-04 5.38889811666E-04 5.63693756424E-04 5.89639373676E-04 6.16779212164E-04 6.45168239336E-04 6.74863952674E-04 7.05926496145E-04 7.38418782016E-04 7.72406618268E-04 8.07958841887E-04 8.45147458273E-04 8.84047787084E-04 9.24738614781E-04 9.67302354194E-04 1.01182521144E-03 1.05839736053E-03 1.10711312597E-03 1.15807117383E-03 1.21137471158E-03 1.26713169711E-03 1.32545505735E-03 1.38646291704E-03 1.45027883795E-03 1.51703206914E-03 1.58685780869E-03 1.65989747761E-03 1.73629900617E-03 1.81621713358E-03 1.89981372137E-03 1.98725808119E-03 2.07872731775E-03 2.17440668752E-03 2.27448997392E-03 2.37917987981E-03 2.48868843801E-03 2.60323744079E-03 2.72305888903E-03 2.84839546209E-03 2.97950100939E-03 3.11664106445E-03 3.26009338275E-03 3.41014850426E-03 3.56711034188E-03 3.73129679697E-03 3.90304040322E-03 4.08268900012E-03 4.27060643747E-03 4.46717331230E-03 4.67278773970E-03 4.88786615917E-03 5.11284417800E-03 5.34817745356E-03 5.59434261615E-03 5.85183823437E-03 6.12118582483E-03 6.40293090845E-03 6.69764411531E-03 7.00592234037E-03 7.32838995238E-03 7.66570005847E-03 8.01853582686E-03 8.38761187057E-03 8.77367569472E-03 9.17750921048E-03 9.59993031873E-03 1.00417945666E-02 1.05039968801E-02 1.09874733770E-02 1.14932032623E-02 1.20222108120E-02 1.25755674471E-02 1.31543939038E-02 1.37598625036E-02 1.43931995272E-02 1.50556876987E-02 1.57486687830E-02 1.64735463034E-02 1.72317883849E-02 1.80249307267E-02 1.88545797130E-02 1.97224156667E-02 2.06301962520E-02 2.15797600350E-02 2.25730302068E-02 2.36120184788E-02 2.46988291576E-02 2.58356634059E-02 2.70248237018E-02 2.82687185012E-02 2.95698671162E-02 3.09309048173E-02 3.23545881711E-02 3.38438006229E-02 3.54015583367E-02 3.70310163044E-02 3.87354747351E-02 4.05183857397E-02 4.23833603223E-02 4.43341756937E-02 4.63747829217E-02 4.85093149333E-02 5.07420948853E-02 5.30776449202E-02 5.55206953248E-02 5.80761941113E-02 6.07493170379E-02 6.35454780920E-02 6.64703404555E-02 6.95298279741E-02 7.27301371555E-02 7.60777497197E-02 7.95794457259E-02 8.32423173054E-02 8.70737830248E-02 9.10816029116E-02 9.52738941707E-02 9.96591476245E-02 1.04246244910E-01 1.09044476467E-01 1.14063560353E-01 1.19313661930E-01 1.24805414447E-01 1.30549940579E-01 1.36558874955E-01 1.42844387720E-01 1.49419209187E-01 1.56296655615E-01 1.63490656184E-01 1.71015781203E-01 1.78887271623E-01 1.87121069900E-01 1.95733852292E-01 2.04743062624E-01 2.14166947628E-01 2.24024593891E-01 2.34335966514E-01 2.45121949553E-01 2.56404388307E-01 2.68206133572E-01 2.80551087915E-01 2.93464254087E-01 3.06971785662E-01 3.21101040008E-01 3.35880633694E-01 3.51340500448E-01 3.67511951783E-01 3.84427740414E-01 4.02122126595E-01 4.20630947504E-01 4.39991689829E-01 4.60243565690E-01 4.81427592055E-01 5.03586673819E-01 5.26765690693E-01 5.51011588109E-01 5.76373472294E-01 6.02902709732E-01 6.30653031194E-01 6.59680640565E-01 6.90044328674E-01 7.21805592365E-01 7.55028759051E-01 7.89781117000E-01 8.26133051612E-01 8.64158187977E-01 9.03933539993E-01 9.45539666338E-01 9.89060833639E-01 1.03458518713E+00 1.08220492919E+00 1.13201650606E+00 1.18412080322E+00 1.23862334966E+00 1.29563453168E+00 1.35526981640E+00 1.41764998564E+00 1.48290138058E+00 1.55115615759E+00 1.62255255590E+00 1.69723517764E+00 1.77535528063E+00 1.85707108478E+00 1.94254809251E+00 2.03195942397E+00 2.12548616768E+00 2.22331774724E+00 2.32565230505E+00 2.43269710354E+00 2.54466894502E+00 2.66179461074E+00 2.78431132019E+00 2.91246721158E+00 3.04652184438E+00 3.18674672504E+00 3.33342585686E+00 3.48685631522E+00 3.64734884922E+00 3.81522851109E+00 3.99083531452E+00 4.17452492329E+00 4.36666937165E+00 -2.97233180461E+01 -2.97233157749E+01 -2.97233132899E+01 -2.97233105707E+01 -2.97233075956E+01 -2.97233043402E+01 -2.97233007783E+01 -2.97232968809E+01 -2.97232926165E+01 -2.97232879504E+01 -2.97232828450E+01 -2.97232772588E+01 -2.97232711465E+01 -2.97232644586E+01 -2.97232571408E+01 -2.97232491339E+01 -2.97232403730E+01 -2.97232307870E+01 -2.97232202983E+01 -2.97232088218E+01 -2.97231962645E+01 -2.97231825247E+01 -2.97231674909E+01 -2.97231510414E+01 -2.97231330427E+01 -2.97231133490E+01 -2.97230918008E+01 -2.97230682232E+01 -2.97230424253E+01 -2.97230141980E+01 -2.97229833124E+01 -2.97229495182E+01 -2.97229125416E+01 -2.97228720827E+01 -2.97228278138E+01 -2.97227793760E+01 -2.97227263767E+01 -2.97226683865E+01 -2.97226049352E+01 -2.97225355087E+01 -2.97224595442E+01 -2.97223764262E+01 -2.97222854810E+01 -2.97221859716E+01 -2.97220770915E+01 -2.97219579583E+01 -2.97218276067E+01 -2.97216849803E+01 -2.97215289232E+01 -2.97213581710E+01 -2.97211713400E+01 -2.97209669163E+01 -2.97207432435E+01 -2.97204985093E+01 -2.97202307308E+01 -2.97199377385E+01 -2.97196171588E+01 -2.97192663944E+01 -2.97188826041E+01 -2.97184626789E+01 -2.97180032176E+01 -2.97175004987E+01 -2.97169504509E+01 -2.97163486199E+01 -2.97156901324E+01 -2.97149696569E+01 -2.97141813604E+01 -2.97133188619E+01 -2.97123751802E+01 -2.97113426785E+01 -2.97102130019E+01 -2.97089770111E+01 -2.97076247081E+01 -2.97061451565E+01 -2.97045263931E+01 -2.97027553322E+01 -2.97008176604E+01 -2.96986977224E+01 -2.96963783951E+01 -2.96938409515E+01 -2.96910649105E+01 -2.96880278744E+01 -2.96847053500E+01 -2.96810705546E+01 -2.96770942036E+01 -2.96727442786E+01 -2.96679857750E+01 -2.96627804264E+01 -2.96570864043E+01 -2.96508579906E+01 -2.96440452213E+01 -2.96365934982E+01 -2.96284431665E+01 -2.96195290552E+01 -2.96097799777E+01 -2.95991181891E+01 -2.95874587969E+01 -2.95747091224E+01 -2.95607680076E+01 -2.95455250658E+01 -2.95288598702E+01 -2.95106410780E+01 -2.94907254849E+01 -2.94689570073E+01 -2.94451655867E+01 -2.94191660146E+01 -2.93907566733E+01 -2.93597181900E+01 -2.93258120033E+01 -2.92887788384E+01 -2.92483370943E+01 -2.92041811419E+01 -2.91559795373E+01 -2.91033731569E+01 -2.90459732622E+01 -2.89833595069E+01 -2.89150779038E+01 -2.88406387727E+01 -2.87595146990E+01 -2.86711385380E+01 -2.85749015095E+01 -2.84701514398E+01 -2.83561912153E+01 -2.82322775312E+01 -2.80976200300E+01 -2.79513809446E+01 -2.77926753801E+01 -2.76205723877E+01 -2.74340970108E+01 -2.72322335051E+01 -2.70139299592E+01 -2.67781045684E+01 -2.65236538364E+01 -2.62494629971E+01 -2.59544189625E+01 -2.56374261068E+01 -2.52974251837E+01 -2.49334156482E+01 -2.45444815981E+01 -2.41298214709E+01 -2.36887815042E+01 -2.32208928061E+01 -2.27259116571E+01 -2.22038623889E+01 -2.16550818419E+01 -2.10802640029E+01 -2.04805029652E+01 -1.98573318636E+01 -1.92127549344E+01 -1.85492693831E+01 -1.78698733791E+01 -1.71780562968E+01 -1.64777674065E+01 -1.57733596623E+01 -1.50695061691E+01 -1.43710883999E+01 -1.36830573315E+01 -1.30102713364E+01 -1.23573177725E+01 -1.17283284789E+01 -1.11268023961E+01 -1.05554507350E+01 -1.00160808847E+01 -9.50953398522E+00 -9.03568737431E+00 -8.59352689059E+00 -8.18128576655E+00 -7.79663764757E+00 -7.43692277738E+00 -7.09938050338E+00 -6.78135969854E+00 -6.48048242196E+00 -6.19474483595E+00 -5.92255131515E+00 -5.66268995596E+00 -5.41426716178E+00 -5.17662327195E+00 -4.94924963820E+00 -4.73172139457E+00 -4.52365205933E+00 -4.32466891129E+00 -4.13440371905E+00 -3.95249226997E+00 -3.77857735393E+00 -3.61231199438E+00 -3.45336163328E+00 -3.30140514752E+00 -3.15613503599E+00 -3.01725715251E+00 -2.88449024086E+00 -2.75756540678E+00 -2.63622558490E+00 -2.52022502071E+00 -2.40932877345E+00 -2.30331224032E+00 -2.20196070163E+00 -2.10506888585E+00 -2.01244055396E+00 -1.92388810192E+00 -1.83923218077E+00 -1.75830133332E+00 -1.68093164696E+00 -1.60696642162E+00 -1.53625585246E+00 -1.46865672641E+00 -1.40403213212E+00 -1.34225118272E+00 -1.28318875067E+00 -1.22672521436E+00 -1.17274621582E+00 -1.12114242916E+00 -1.07180933905E+00 -1.02464702914E+00 -9.79559979624E-01 -9.36456873825E-01 -8.95250413222E-01 -8.55857140650E-01 -8.18197271270E-01 -7.82194530977E-01 -7.47776001918E-01 -7.14871974809E-01 -6.83415807750E-01 -6.53343791254E-01 -6.24595019210E-01 -5.97111265530E-01 -5.70836866221E-01 -5.45718606645E-01 -5.21705613742E-01 -4.98749252996E-01 -4.76803029930E-01 -4.55822495944E-01 -4.35765158285E-01 -4.16590393991E-01 -3.98259367611E-01 -3.80734952553E-01 -3.63981655886E-01 -3.47965546461E-01 -3.32654186181E-01 -3.18016564310E-01 -3.04023034662E-01 -2.90645255556E-01 -2.77856132418E-01 -2.65629762904E-01 -2.53941384436E-01 -2.42767324054E-01 -2.32084950467E-01 -2.21872628218E-01 -2.12109673864E-01 -2.02776314086E-01 -1.93853645642E-01 -1.85323597078E-01 -1.77168892131E-01 -1.69373014736E-01 -1.61920175578E-01 -1.54795280111E-01 -1.47983897985E-01 -1.41472233826E-01 -1.35247099287E-01 -1.29295886344E-01 -1.23606541756E-01 -1.18167542657E-01 -1.12967873214E-01 -1.07997002321E-01 -1.03244862264E-01 -9.87018283368E-02 -9.43586993423E-02 -9.02066789603E-02 -8.62373579305E-02 -8.24426970215E-02 1 0 Beta L 219 1.09119164250E-02 1.14141682567E-02 1.19395372411E-02 1.24890883887E-02 1.30639335918E-02 1.36652383221E-02 1.42942192368E-02 1.49521508762E-02 1.56403651833E-02 1.63602567647E-02 1.71132833675E-02 1.79009697042E-02 1.87249117559E-02 1.95867777263E-02 2.04883128226E-02 2.14313440354E-02 2.24177801346E-02 2.34496197971E-02 2.45289520792E-02 2.56579635859E-02 2.68389403770E-02 2.80742741769E-02 2.93664671488E-02 3.07181361880E-02 3.21320186492E-02 3.36109780717E-02 3.51580094237E-02 3.67762457792E-02 3.84689649919E-02 4.02395939732E-02 4.20917191858E-02 4.40290918706E-02 4.60556342237E-02 4.81754522666E-02 5.03928338776E-02 5.27122740862E-02 5.51384716514E-02 5.76763304148E-02 6.03309974813E-02 6.31078487573E-02 6.60125031801E-02 6.90508417131E-02 7.22290167528E-02 7.55534662947E-02 7.90309185058E-02 8.26684106172E-02 8.64733125671E-02 9.04533266809E-02 9.46165064431E-02 9.89712799992E-02 1.03526459246E-01 1.08291272770E-01 1.13275355656E-01 1.18488796603E-01 1.23942141893E-01 1.29646437497E-01 1.35613213655E-01 1.41854545825E-01 1.48383058059E-01 1.55211954874E-01 1.62355048099E-01 1.69826778680E-01 1.77642257306E-01 1.85817275986E-01 1.94368367049E-01 2.03312794737E-01 2.12668641907E-01 2.22454795713E-01 2.32691018669E-01 2.43397975881E-01 2.54597270950E-01 2.66311495169E-01 2.78564270758E-01 2.91380292739E-01 3.04785383599E-01 3.18806536603E-01 3.33471966638E-01 3.48811177823E-01 3.64854990224E-01 3.81635639943E-01 3.99186794490E-01 4.17543654874E-01 4.36742981469E-01 4.56823200530E-01 4.77824437834E-01 4.99788612210E-01 5.22759511567E-01 5.46782855048E-01 5.71906344793E-01 5.98179810565E-01 6.25655197729E-01 6.54386777629E-01 6.84431054295E-01 7.15847078689E-01 7.48696311060E-01 7.83042741609E-01 8.18953122070E-01 8.56496781721E-01 8.95746066180E-01 9.36775970383E-01 9.79664569977E-01 1.02449277469E+00 1.07134457739E+00 1.12030703095E+00 1.17147003668E+00 1.22492668215E+00 1.28077288844E+00 1.33910733649E+00 1.40003150700E+00 1.46364938723E+00 1.53006700548E+00 1.59939240875E+00 1.67173497490E+00 1.74720489842E+00 1.82591247195E+00 1.90796715133E+00 1.99347642841E+00 2.08254443362E+00 2.17527031529E+00 2.27174606928E+00 2.37205402307E+00 2.47626388713E+00 2.58442905244E+00 2.69658211322E+00 2.81272966021E+00 2.93284598230E+00 3.05686569645E+00 3.18467472687E+00 3.31610011638E+00 3.45089805737E+00 3.58873964402E+00 3.72919488236E+00 3.87171473869E+00 4.01560936397E+00 4.16002775495E+00 4.30393047489E+00 4.44606476658E+00 4.58493808565E+00 4.71879127054E+00 4.84557496510E+00 4.96293187144E+00 5.06818462457E+00 5.15833922433E+00 5.23010336647E+00 5.27992998877E+00 5.30408959717E+00 5.29877811997E+00 5.26026736806E+00 5.18509924185E+00 5.07032501099E+00 4.91378342041E+00 4.71440417631E+00 4.47251535633E+00 4.19012251658E+00 3.87111916315E+00 3.52138354493E+00 3.14871523455E+00 2.76257689930E+00 2.37362465447E+00 1.99304073912E+00 1.63171975386E+00 1.29939594463E+00 1.00382759520E+00 7.50163583134E-01 5.40600675885E-01 3.74396433541E-01 2.48238825614E-01 1.56904914202E-01 9.40843674598E-02 5.32167425136E-02 2.82014768880E-02 1.38831641636E-02 6.27743891557E-03 2.56461220912E-03 9.21317345749E-04 2.75433412799E-04 5.83029321428E-05 1.16326157773E-06 -6.94000232033E-06 -4.55795263725E-06 -1.99740477429E-06 -6.97140527485E-07 -2.03130279228E-07 -5.00983511413E-08 -1.04600475256E-08 -1.83553171967E-09 -2.67484430064E-10 -3.18760278112E-11 -3.05102136875E-12 -2.29888676828E-13 -1.33861922524E-14 -6.11328854205E-16 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 1 Number of nonzero Dij 1 1 1.16957606628E+00 2S 0 2.00 Wavefunction 2.28061240000E-04 2.38558440000E-04 2.49538800000E-04 2.61024580000E-04 2.73039020000E-04 2.85606480000E-04 2.98752390000E-04 3.12503390000E-04 3.26887320000E-04 3.41933330000E-04 3.57671890000E-04 3.74134870000E-04 3.91355630000E-04 4.09369040000E-04 4.28211580000E-04 4.47921440000E-04 4.68538520000E-04 4.90104600000E-04 5.12663350000E-04 5.36260480000E-04 5.60943780000E-04 5.86763250000E-04 6.13771200000E-04 6.42022340000E-04 6.71573900000E-04 7.02485750000E-04 7.34820510000E-04 7.68643690000E-04 8.04023830000E-04 8.41032590000E-04 8.79744970000E-04 9.20239420000E-04 9.62597970000E-04 1.00690650000E-03 1.05325470000E-03 1.10173660000E-03 1.15245050000E-03 1.20549900000E-03 1.26098980000E-03 1.31903540000E-03 1.37975340000E-03 1.44326690000E-03 1.50970470000E-03 1.57920160000E-03 1.65189850000E-03 1.72794280000E-03 1.80748890000E-03 1.89069820000E-03 1.97773950000E-03 2.06878950000E-03 2.16403300000E-03 2.26366360000E-03 2.36788350000E-03 2.47690450000E-03 2.59094810000E-03 2.71024640000E-03 2.83504180000E-03 2.96558830000E-03 3.10215160000E-03 3.24500980000E-03 3.39445400000E-03 3.55078880000E-03 3.71433320000E-03 3.88542090000E-03 4.06440160000E-03 4.25164090000E-03 4.44752220000E-03 4.65244650000E-03 4.86683400000E-03 5.09112480000E-03 5.32577980000E-03 5.57128190000E-03 5.82813710000E-03 6.09687560000E-03 6.37805320000E-03 6.67225250000E-03 6.98008430000E-03 7.30218940000E-03 7.63923960000E-03 7.99194030000E-03 8.36103140000E-03 8.74729010000E-03 9.15153220000E-03 9.57461520000E-03 1.00174400000E-02 1.04809540000E-02 1.09661540000E-02 1.14740890000E-02 1.20058630000E-02 1.25626400000E-02 1.31456460000E-02 1.37561760000E-02 1.43955950000E-02 1.50653480000E-02 1.57669610000E-02 1.65020480000E-02 1.72723210000E-02 1.80795920000E-02 1.89257890000E-02 1.98129560000E-02 2.07432710000E-02 2.17190510000E-02 2.27427690000E-02 2.38170670000E-02 2.49447670000E-02 2.61288960000E-02 2.73726990000E-02 2.86796610000E-02 3.00535350000E-02 3.14983670000E-02 3.30185220000E-02 3.46187250000E-02 3.63040940000E-02 3.80801840000E-02 3.99530350000E-02 4.19292250000E-02 4.40159300000E-02 4.62209910000E-02 4.85529910000E-02 5.10213370000E-02 5.36363540000E-02 5.64093920000E-02 5.93529420000E-02 6.24807640000E-02 6.58080320000E-02 6.93514920000E-02 7.31296380000E-02 7.71628970000E-02 8.14738390000E-02 8.60874020000E-02 9.10311230000E-02 9.63353900000E-02 1.02033710000E-01 1.08162940000E-01 1.14763610000E-01 1.21880100000E-01 1.29560890000E-01 1.37858740000E-01 1.46830770000E-01 1.56538460000E-01 1.67047540000E-01 1.78427610000E-01 1.90751620000E-01 2.04094960000E-01 2.18534240000E-01 2.34145590000E-01 2.51002410000E-01 2.69172570000E-01 2.88714910000E-01 3.09675080000E-01 3.32080720000E-01 3.55936040000E-01 3.81216000000E-01 4.07860320000E-01 4.35767680000E-01 4.64790660000E-01 4.94731850000E-01 5.25341850000E-01 5.56319700000E-01 5.87316160000E-01 6.17940180000E-01 6.47768460000E-01 6.76357740000E-01 7.03259030000E-01 7.28032750000E-01 7.50263620000E-01 7.69573940000E-01 7.85634540000E-01 7.98172620000E-01 8.06976450000E-01 8.11897290000E-01 8.12848980000E-01 8.09806150000E-01 8.02801390000E-01 7.91922100000E-01 7.77307050000E-01 7.59142580000E-01 7.37658640000E-01 7.13124220000E-01 6.85842340000E-01 6.56144670000E-01 6.24385610000E-01 5.90936210000E-01 5.56177930000E-01 5.20496240000E-01 4.84274450000E-01 4.47887530000E-01 4.11696340000E-01 3.76042110000E-01 3.41241450000E-01 3.07581890000E-01 2.75318040000E-01 2.44668500000E-01 2.15813570000E-01 1.88893830000E-01 1.64009610000E-01 1.41221420000E-01 1.20551280000E-01 1.01984980000E-01 8.54750970000E-02 7.09447920000E-02 5.82921310000E-02 4.73948360000E-02 3.81152710000E-02 3.03054550000E-02 2.38119420000E-02 1.84803600000E-02 1.41594970000E-02 1.07047720000E-02 7.98103950000E-03 5.86466740000E-03 4.24489950000E-03 3.02452910000E-03 2.11996200000E-03 1.46075900000E-03 9.88770080000E-04 6.56975680000E-04 4.28149640000E-04 2.73446490000E-04 1.71001470000E-04 1.04611490000E-04 6.25449480000E-05 3.65088500000E-05 2.07842100000E-05 1.15267480000E-05 6.21992080000E-06 3.26108620000E-06 1.65956250000E-06 8.18667970000E-07 3.90913520000E-07 1.80412660000E-07 8.03596320000E-08 3.45152480000E-08 1.43387890000E-08 5.93228830000E-09 2.35424230000E-09 8.94471490000E-10 3.24711200000E-10 1.12391220000E-10 3.70099790000E-11 1.15680410000E-11 3.42383290000E-12 9.57164160000E-13 2.52081250000E-13 6.23708290000E-14 1.44564310000E-14 3.12948980000E-15 6.30743890000E-16 1.17969830000E-16 2.04048250000E-17 3.25218780000E-18 4.75843400000E-19 6.36631050000E-20 7.75635790000E-21 8.56845860000E-22 8.54407110000E-23 7.65414440000E-24 6.12994000000E-25 4.36619470000E-26 2.75101980000E-27 1.52467280000E-28 7.38903300000E-30 3.11203400000E-31 1.13172540000E-32 3.52974210000E-34 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 0.00000000000E+00 2P 1 2.00 Wavefunction 8.98957130000E-07 9.83615700000E-07 1.07624690000E-06 1.17760160000E-06 1.28850130000E-06 1.40984480000E-06 1.54261580000E-06 1.68789030000E-06 1.84684590000E-06 2.02077100000E-06 2.21107530000E-06 2.41930140000E-06 2.64713680000E-06 2.89642840000E-06 3.16919680000E-06 3.46765280000E-06 3.79421550000E-06 4.15153180000E-06 4.54249780000E-06 4.97028250000E-06 5.43835320000E-06 5.95050370000E-06 6.51088500000E-06 7.12403930000E-06 7.79493630000E-06 8.52901360000E-06 9.33222110000E-06 1.02110690000E-05 1.11726800000E-05 1.22248480000E-05 1.33761020000E-05 1.46357710000E-05 1.60140660000E-05 1.75221570000E-05 1.91722670000E-05 2.09777700000E-05 2.29532980000E-05 2.51148630000E-05 2.74799830000E-05 3.00678260000E-05 3.28993630000E-05 3.59975440000E-05 3.93874750000E-05 4.30966280000E-05 4.71550620000E-05 5.15956640000E-05 5.64544190000E-05 6.17706980000E-05 6.75875790000E-05 7.39521970000E-05 8.09161190000E-05 8.85357710000E-05 9.68728870000E-05 1.05995010000E-04 1.15976040000E-04 1.26896840000E-04 1.38845870000E-04 1.51919910000E-04 1.66224870000E-04 1.81876590000E-04 1.99001830000E-04 2.17739260000E-04 2.38240600000E-04 2.60671830000E-04 2.85214540000E-04 3.12067380000E-04 3.41447680000E-04 3.73593200000E-04 4.08764000000E-04 4.47244620000E-04 4.89346260000E-04 5.35409390000E-04 5.85806410000E-04 6.40944640000E-04 7.01269620000E-04 7.67268660000E-04 8.39474740000E-04 9.18470730000E-04 1.00489410000E-03 1.09944200000E-03 1.20287660000E-03 1.31603150000E-03 1.43981810000E-03 1.57523260000E-03 1.72336440000E-03 1.88540410000E-03 2.06265320000E-03 2.25653400000E-03 2.46860100000E-03 2.70055250000E-03 2.95424410000E-03 3.23170270000E-03 3.53514210000E-03 3.86697990000E-03 4.22985560000E-03 4.62665040000E-03 5.06050850000E-03 5.53486060000E-03 6.05344890000E-03 6.62035380000E-03 7.24002350000E-03 7.91730500000E-03 8.65747810000E-03 9.46629150000E-03 1.03500010000E-02 1.13154120000E-02 1.23699220000E-02 1.35215680000E-02 1.47790740000E-02 1.61519070000E-02 1.76503260000E-02 1.92854410000E-02 2.10692740000E-02 2.30148110000E-02 2.51360720000E-02 2.74481650000E-02 2.99673510000E-02 3.27110970000E-02 3.56981350000E-02 3.89485130000E-02 4.24836320000E-02 4.63262830000E-02 5.05006690000E-02 5.50324050000E-02 5.99485040000E-02 6.52773380000E-02 7.10485660000E-02 7.72930280000E-02 8.40425970000E-02 9.13299840000E-02 9.91884820000E-02 1.07651650000E-01 1.16752930000E-01 1.26525160000E-01 1.37000060000E-01 1.48207520000E-01 1.60174940000E-01 1.72926350000E-01 1.86481480000E-01 2.00854780000E-01 2.16054300000E-01 2.32080610000E-01 2.48925590000E-01 2.66571320000E-01 2.84989010000E-01 3.04138010000E-01 3.23965010000E-01 3.44403510000E-01 3.65373510000E-01 3.86781650000E-01 4.08521720000E-01 4.30475570000E-01 4.52514570000E-01 4.74501410000E-01 4.96292330000E-01 5.17739610000E-01 5.38694190000E-01 5.59008350000E-01 5.78538110000E-01 5.97145370000E-01 6.14699520000E-01 6.31078490000E-01 6.46169150000E-01 6.59867260000E-01 6.72076870000E-01 6.82709610000E-01 6.91684020000E-01 6.98925100000E-01 7.04364440000E-01 7.07940810000E-01 7.09601510000E-01 7.09304040000E-01 7.07018090000E-01 7.02727520000E-01 6.96432030000E-01 6.88148310000E-01 6.77910670000E-01 6.65771070000E-01 6.51798520000E-01 6.36078260000E-01 6.18710530000E-01 5.99809270000E-01 5.79500700000E-01 5.57921850000E-01 5.35219180000E-01 5.11547050000E-01 4.87066300000E-01 4.61942730000E-01 4.36345600000E-01 4.10446070000E-01 3.84415550000E-01 3.58424000000E-01 3.32638200000E-01 3.07219910000E-01 2.82323990000E-01 2.58096500000E-01 2.34672880000E-01 2.12176130000E-01 1.90715170000E-01 1.70383370000E-01 1.51257350000E-01 1.33396060000E-01 1.16840270000E-01 1.01612380000E-01 8.77167280000E-02 7.51402570000E-02 6.38536040000E-02 5.38125840000E-02 4.49599720000E-02 3.72275650000E-02 3.05384160000E-02 2.48091760000E-02 1.99524460000E-02 1.58790590000E-02 1.25002080000E-02 9.72936010000E-03 7.48388970000E-03 5.68641140000E-03 4.26577580000E-03 3.15773900000E-03 2.30531370000E-03 1.65883430000E-03 1.17577310000E-03 8.20355700000E-04 5.63023490000E-04 3.79794600000E-04 2.51580610000E-04 1.63573110000E-04 1.04304180000E-04 6.51708470000E-05 3.98620180000E-05 2.38453890000E-05 1.39376870000E-05 7.95469470000E-06 4.43428940000E-06 2.42381730000E-06 1.32243450000E-06 7.01179730000E-07 3.60817550000E-07 1.79947130000E-07 8.68499360000E-08 4.05042750000E-08 1.82241930000E-08 7.89749940000E-09 3.29055730000E-09 1.31582470000E-09 5.04021790000E-10 1.84569310000E-10 6.44800160000E-11 2.14437850000E-11 6.77329950000E-12 2.02716060000E-12 5.73435020000E-13 1.52917770000E-13 3.83377820000E-14 9.01061930000E-15 1.97946330000E-15 4.05184260000E-16 7.70291150000E-17 1.35542170000E-17 2.19969820000E-18 3.28021010000E-19 4.47709660000E-20 5.57026670000E-21 6.29053060000E-22 6.41936620000E-23 5.89200780000E-24 4.84038870000E-25 3.54099120000E-26 1.04025474629E-07 1.13822193590E-07 1.24541542026E-07 1.36270436219E-07 1.49103933356E-07 1.63146098161E-07 1.78510740388E-07 1.95322435470E-07 2.13717461633E-07 2.33844971361E-07 2.55868139500E-07 2.79965507938E-07 3.06332472932E-07 3.35182800416E-07 3.66750402109E-07 4.01291282055E-07 4.39085481590E-07 4.80439508315E-07 5.25688689439E-07 5.75200012236E-07 6.29375000012E-07 6.88653040090E-07 7.53514955146E-07 8.24486873990E-07 9.02144528386E-07 9.87117946052E-07 1.08009654453E-06 1.18183477621E-06 1.29315829597E-06 1.41497052870E-06 1.54826026469E-06 1.69410959183E-06 1.85370260432E-06 2.02833545146E-06 2.21942607779E-06 2.42852720523E-06 2.65733801768E-06 2.90771719069E-06 3.18170085034E-06 3.48151692123E-06 3.80960362579E-06 4.16863033562E-06 4.56151930878E-06 4.99147002558E-06 5.46198450835E-06 5.97689686523E-06 6.54040645010E-06 7.15711060523E-06 7.83204322139E-06 8.57071784550E-06 9.37917248681E-06 1.02640229534E-05 1.12325132516E-05 1.22925816885E-05 1.34529249975E-05 1.47230767134E-05 1.61134803667E-05 1.76355872483E-05 1.93019505136E-05 2.11263353922E-05 2.31238393729E-05 2.53110229751E-05 2.77060594082E-05 3.03288907462E-05 3.32014153998E-05 3.63476727844E-05 3.97940804753E-05 4.35696606289E-05 4.77063223825E-05 5.22391589586E-05 5.72067804805E-05 6.26516904483E-05 6.86207024128E-05 7.51654042268E-05 8.23426834039E-05 9.02153092407E-05 9.88525893484E-05 1.08331117031E-04 1.18735587637E-04 1.30159764940E-04 1.42707516373E-04 1.56494046005E-04 1.71647235537E-04 1.88309227944E-04 2.06638178018E-04 2.26810290741E-04 2.49022143550E-04 2.73493328146E-04 3.00469474544E-04 3.30225815150E-04 3.63071133919E-04 3.99352560968E-04 4.39460770142E-04 4.83836487816E-04 5.32977475145E-04 5.87446964236E-04 6.47883638011E-04 7.15012657496E-04 7.89659465715E-04 8.72764619790E-04 9.65402464120E-04 1.06880178961E-03 1.18437093768E-03 1.31372671049E-03 1.45872784277E-03 1.62151550982E-03 1.80455924166E-03 2.01071151251E-03 2.24327198859E-03 2.50606244681E-03 2.80351360594E-03 3.14076871038E-03 3.52380309610E-03 3.95956387768E-03 4.45613424260E-03 5.02292334194E-03 5.67088843944E-03 6.41279175193E-03 7.26349955505E-03 8.24032698836E-03 9.36343491665E-03 1.06562880048E-02 1.21461785870E-02 1.38648229402E-02 1.58490404151E-02 1.81415205980E-02 2.07916853693E-02 2.38566497017E-02 2.74022891038E-02 3.15044135211E-02 3.62500406322E-02 4.17387702283E-02 4.80842492799E-02 5.54156754049E-02 6.38794052405E-02 7.36404555211E-02 8.48840712432E-02 9.78171094374E-02 1.12669234804E-01 1.29693864216E-01 1.49168682337E-01 1.71395643097E-01 1.96700259779E-01 2.25430042688E-01 2.57951899746E-01 2.94648172886E-01 3.35911075060E-01 3.82135300281E-01 4.33708202132E-01 4.90997399899E-01 5.54335200615E-01 6.23999361875E-01 7.00190149437E-01 7.83003257445E-01 8.72399095499E-01 9.68169322772E-01 1.06990206749E+00 1.17694878946E+00 1.28839590666E+00 1.40304572942E+00 1.51941113189E+00 1.63572807662E+00 1.74998872574E+00 1.85999612819E+00 1.96343800852E+00 2.05797582216E+00 2.14134166530E+00 2.21143585170E+00 2.26641759131E+00 2.30478236264E+00 2.32542302501E+00 2.32767137089E+00 2.31132116033E+00 2.27663207830E+00 2.22431636976E+00 2.15550869307E+00 2.07172066654E+00 1.97478277363E+00 1.86677492765E+00 1.74995053636E+00 1.62665709580E+00 1.49925710071E+00 1.37005333118E+00 1.24122136105E+00 1.11475181299E+00 9.92404254573E-01 8.75673640250E-01 7.65769924338E-01 6.63610302265E-01 5.69823407153E-01 4.84763868276E-01 4.08535573851E-01 3.41021693983E-01 2.81919140193E-01 2.30775428683E-01 1.87025910969E-01 1.50029700149E-01 1.19102642503E-01 9.35464244275E-02 7.26729699594E-02 5.58238988819E-02 4.23849627201E-02 3.17958383463E-02 2.35556993053E-02 1.72252899476E-02 1.24261336077E-02 8.83761289904E-03 6.19257110410E-03 4.27198245163E-03 2.89917717466E-03 1.93397835100E-03 1.26702877113E-03 8.14495755319E-04 5.13277507214E-04 3.16778033799E-04 1.91276228453E-04 1.12880444172E-04 6.50371734486E-05 3.65432323175E-05 2.00011141897E-05 1.06508296385E-05 5.51128621075E-06 2.76755055762E-06 1.34683091582E-06 6.34256632422E-07 2.88565251208E-07 1.26606876022E-07 5.35178329255E-08 2.17600643654E-08 8.49478422416E-09 3.17802605552E-09 1.13721806846E-09 3.88520620425E-10 1.26554746742E-10 3.93259153500E-11 1.17497916925E-11 3.49766761374E-12 9.83306238400E-13 2.60378634040E-13 6.47619419300E-14 1.50858230340E-14 3.28119261000E-15 6.64242422835E-16 1.24740993673E-16 2.16555346969E-17 3.46278928268E-18 5.08075929609E-19 6.81316603885E-20 8.31534492675E-21 9.19671830253E-22 9.17551722334E-23 8.21876019639E-24 6.57655444325E-25 4.67676887635E-26 2.93957105736E-27 1.62382520339E-28 7.83654991209E-30 3.28348569103E-31 1.18669691154E-32 3.67433596966E-34 9.67734434217E-36 2.15195566003E-37 4.00887879315E-39 6.20557422183E-41 7.91415504591E-43 8.24165248194E-45 6.94315118305E-47 4.68587255342E-49 2.50772373570E-51 TDDFPT/Examples/SiH4/0000755000175000017500000000000012341371517012454 5ustar mbambaTDDFPT/Examples/SiH4/SiH4.tddfpt-st-ref0000644000175000017500000001306112341371500015621 0ustar mbamba Program TDDFPT v.4.99 starts on 12Jan2012 at 11:54:28 This program is part of the open-source Quantum ESPRESSO suite for quantum simulation of materials; please cite "P. Giannozzi et al., J. Phys.:Condens. Matter 21 395502 (2009); URL http://www.quantum-espresso.org", in publications or presentations arising from this work. More details at http://www.quantum-espresso.org/quote.php Parallel version (MPI), running on 4 processors R & G space division: proc/pool = 4 ---------------------------------------- This is TDDFPT (Time Dependent Density Functional Perturbation Theory) Sub Version: 0.9 ---------------------------------------- Ultrasoft (Vanderbilt) Pseudopotentials Info: using nr1, nr2, nr3 values from input Info: using nr1s, nr2s, nr3s values from input IMPORTANT: XC functional enforced from input : Exchange-correlation = SLA PW PBE PBE ( 1 4 3 4 0) EXX-fraction = 0.00 Any further DFT definition will be discarded Please, verify this is what you really want Parallelization info -------------------- sticks: dense smooth PW G-vecs: dense smooth PW Min 1614 646 161 97286 24570 3072 Max 1616 647 166 97292 24623 3074 Sum 6461 2585 657 389159 98385 12293 Tot 3231 1293 329 negative rho (up, down): 0.141E-02 0.000E+00 Subspace diagonalization in iterative solution of the eigenvalue problem: a serial algorithm will be used Lanczos linear response spectrum calculation Number of Lanczos iterations = 5 Gamma point algorithm lr_wfcinit_spectrum: finished lr_solve_e Norm of initial Lanczos vectors= 2.201242292234776 Starting Lanczos loop 1 Lanczos iteration: 1 z1= 1 0.000000000000000E+00 0.000000000000000E+00 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal alpha(00000001)=0.000000000000000E+00 beta (00000002)=0.139836574130471E+01 gamma(00000002)=0.139836574130471E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 2 z1= 1 0.141271388852883E+01 0.000000000000000E+00 alpha(00000002)=0.000000000000000E+00 beta (00000003)=0.583916600557335E+01 gamma(00000003)=0.583916600557335E+01 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 3 z1= 1 0.000000000000000E+00 0.000000000000000E+00 alpha(00000003)=0.000000000000000E+00 beta (00000004)=0.140885952964573E+02 gamma(00000004)=0.140885952964573E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 4 z1= 1 -.471987988764546E+00 0.000000000000000E+00 alpha(00000004)=0.000000000000000E+00 beta (00000005)=0.136313166156627E+02 gamma(00000005)=0.136313166156627E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 5 z1= 1 0.000000000000000E+00 0.000000000000000E+00 alpha(00000005)=0.000000000000000E+00 beta (00000006)=0.120975960400089E+02 gamma(00000006)=0.120975960400089E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction End of Lanczos iterations Finished linear response calculation... lr_main : 15.51s CPU 15.95s WALL ( 1 calls) lr_solve_e : 0.45s CPU 0.46s WALL ( 1 calls) one_step : 11.19s CPU 11.55s WALL ( 5 calls) lr_apply : 11.18s CPU 11.54s WALL ( 12 calls) lr_apply_int : 11.03s CPU 11.39s WALL ( 6 calls) lr_apply_no : 0.15s CPU 0.15s WALL ( 6 calls) lr_apply : 11.18s CPU 11.54s WALL ( 12 calls) h_psi : 0.29s CPU 0.29s WALL ( 12 calls) lr_calc_dens : 3.77s CPU 3.83s WALL ( 6 calls) lr_ortho : 0.00s CPU 0.00s WALL ( 10 calls) interaction : 0.06s CPU 0.06s WALL ( 6 calls) lr_dot : 0.00s CPU 0.00s WALL ( 8 calls) US routines s_psi : 0.01s CPU 0.01s WALL ( 57 calls) lr_sm1_psi : 0.01s CPU 0.01s WALL ( 13 calls) General routines calbec : 0.02s CPU 0.03s WALL ( 81 calls) fft : 3.22s CPU 3.28s WALL ( 101 calls) ffts : 0.08s CPU 0.08s WALL ( 13 calls) fftw : 0.65s CPU 0.64s WALL ( 136 calls) interpolate : 0.53s CPU 0.57s WALL ( 13 calls) davcio : 0.00s CPU 0.00s WALL ( 11 calls) addusdens : 3.37s CPU 3.42s WALL ( 6 calls) Parallel routines fft_scatter : 1.12s CPU 1.15s WALL ( 250 calls) TDDFPT : 15.51s CPU 15.95s WALL This run was terminated on: 11:54:44 12Jan2012 =------------------------------------------------------------------------------= JOB DONE. =------------------------------------------------------------------------------= TDDFPT/Examples/SiH4/SiH4.pw-ref0000644000175000017500000002452712341371500014347 0ustar mbamba Program PWSCF v.4.99 starts on 12Jan2012 at 11:54:14 This program is part of the open-source Quantum ESPRESSO suite for quantum simulation of materials; please cite "P. Giannozzi et al., J. Phys.:Condens. Matter 21 395502 (2009); URL http://www.quantum-espresso.org", in publications or presentations arising from this work. More details at http://www.quantum-espresso.org/quote.php Parallel version (MPI), running on 4 processors R & G space division: proc/pool = 4 Current dimensions of program PWSCF are: Max number of different atomic species (ntypx) = 10 Max number of k-points (npk) = 40000 Max angular momentum in pseudopotentials (lmaxx) = 3 Waiting for input... Reading input from stdin Warning: card &IONS ignored Warning: card / ignored gamma-point specific algorithms are used Subspace diagonalization in iterative solution of the eigenvalue problem: a serial algorithm will be used Parallelization info -------------------- sticks: dense smooth PW G-vecs: dense smooth PW Min 1614 646 161 97286 24570 3072 Max 1616 647 166 97292 24623 3074 Sum 6461 2585 657 389159 98385 12293 Tot 3231 1293 329 Title: TDDFPT Example SiH4 (US PPS) bravais-lattice index = 1 lattice parameter (alat) = 18.0000 a.u. unit-cell volume = 5832.0000 (a.u.)^3 number of atoms/cell = 5 number of atomic types = 2 number of electrons = 8.00 number of Kohn-Sham states= 4 kinetic-energy cutoff = 25.0000 Ry charge density cutoff = 250.0000 Ry convergence threshold = 1.0E-06 mixing beta = 0.7000 number of iterations used = 8 plain mixing Exchange-correlation = SLA PW PBE PBE ( 1 4 3 4 0) EXX-fraction = 0.00 celldm(1)= 18.000000 celldm(2)= 0.000000 celldm(3)= 0.000000 celldm(4)= 0.000000 celldm(5)= 0.000000 celldm(6)= 0.000000 crystal axes: (cart. coord. in units of alat) a(1) = ( 1.000000 0.000000 0.000000 ) a(2) = ( 0.000000 1.000000 0.000000 ) a(3) = ( 0.000000 0.000000 1.000000 ) reciprocal axes: (cart. coord. in units 2 pi/alat) b(1) = ( 1.000000 0.000000 0.000000 ) b(2) = ( 0.000000 1.000000 0.000000 ) b(3) = ( 0.000000 0.000000 1.000000 ) PseudoPot. # 1 for Si read from file: ../pseudo/Si.pbe-n-van.UPF MD5 check sum: 8a97496598b7338af554a5de8957bfee Pseudo is Ultrasoft + core correction, Zval = 4.0 Generated by new atomic code, or converted to UPF format Using radial grid of 899 points, 6 beta functions with: l(1) = 0 l(2) = 0 l(3) = 1 l(4) = 1 l(5) = 2 l(6) = 2 Q(r) pseudized with 8 coefficients, rinner = 0.900 0.900 0.900 0.900 0.900 PseudoPot. # 2 for H read from file: ../pseudo/H.pbe-van_ak.UPF MD5 check sum: 077eb6d537518a38cb46c6de387227b7 Pseudo is Ultrasoft, Zval = 1.0 Generated by new atomic code, or converted to UPF format Using radial grid of 615 points, 1 beta functions with: l(1) = 0 Q(r) pseudized with 8 coefficients, rinner = 0.800 atomic species valence mass pseudopotential Si 4.00 1.00000 Si( 1.00) H 1.00 1.00000 H ( 1.00) 24 Sym. Ops. (no inversion) found Cartesian axes site n. atom positions (alat units) 1 Si tau( 1) = ( 0.0000000 0.0000000 0.0000000 ) 2 H tau( 2) = ( 0.0904952 0.0904952 0.0904952 ) 3 H tau( 3) = ( -0.0904952 -0.0904952 0.0904952 ) 4 H tau( 4) = ( 0.0904952 -0.0904952 -0.0904952 ) 5 H tau( 5) = ( -0.0904952 0.0904952 -0.0904952 ) number of k points= 1 cart. coord. in units 2pi/alat k( 1) = ( 0.0000000 0.0000000 0.0000000), wk = 2.0000000 Dense grid: 194580 G-vectors FFT dimensions: ( 96, 96, 96) Smooth grid: 49193 G-vectors FFT dimensions: ( 60, 60, 60) Largest allocated arrays est. size (Mb) dimensions Kohn-Sham Wavefunctions 0.09 Mb ( 1537, 4) NL pseudopotentials 0.52 Mb ( 1537, 22) Each V/rho on FFT grid 3.38 Mb ( 221184) Each G-vector array 0.37 Mb ( 48645) G-vector shells 0.01 Mb ( 1688) Largest temporary arrays est. size (Mb) dimensions Auxiliary wavefunctions 0.19 Mb ( 1537, 16) Each subspace H/S matrix 0.00 Mb ( 16, 16) Each matrix 0.00 Mb ( 22, 4) Arrays for rho mixing 27.00 Mb ( 221184, 8) Initial potential from superposition of free atoms Check: negative starting charge= -0.000465 starting charge 7.99929, renormalised to 8.00000 negative rho (up, down): 0.465E-03 0.000E+00 Starting wfc are 8 randomized atomic wfcs total cpu time spent up to now is 2.2 secs per-process dynamical memory: 42.5 Mb Self-consistent Calculation iteration # 1 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 1.00E-02, avg # of iterations = 2.0 negative rho (up, down): 0.964E-03 0.000E+00 total cpu time spent up to now is 4.4 secs total energy = -14.22861503 Ry Harris-Foulkes estimate = -14.35028904 Ry estimated scf accuracy < 0.27396875 Ry iteration # 2 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 3.42E-03, avg # of iterations = 1.0 negative rho (up, down): 0.137E-02 0.000E+00 total cpu time spent up to now is 6.5 secs total energy = -14.24798278 Ry Harris-Foulkes estimate = -14.25006409 Ry estimated scf accuracy < 0.00607673 Ry iteration # 3 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 7.60E-05, avg # of iterations = 2.0 negative rho (up, down): 0.137E-02 0.000E+00 total cpu time spent up to now is 8.8 secs total energy = -14.24956798 Ry Harris-Foulkes estimate = -14.24966384 Ry estimated scf accuracy < 0.00026899 Ry iteration # 4 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 3.36E-06, avg # of iterations = 3.0 negative rho (up, down): 0.140E-02 0.000E+00 total cpu time spent up to now is 11.0 secs total energy = -14.24965850 Ry Harris-Foulkes estimate = -14.24965604 Ry estimated scf accuracy < 0.00000961 Ry iteration # 5 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 1.20E-07, avg # of iterations = 2.0 negative rho (up, down): 0.141E-02 0.000E+00 total cpu time spent up to now is 13.1 secs End of self-consistent calculation k = 0.0000 0.0000 0.0000 ( 6147 PWs) bands (ev): -13.1054 -8.1531 -8.1530 -8.1529 ! total energy = -14.24965990 Ry Harris-Foulkes estimate = -14.24965997 Ry estimated scf accuracy < 0.00000031 Ry The total energy is the sum of the following terms: one-electron contribution = -23.81019891 Ry hartree contribution = 12.55774217 Ry xc contribution = -7.03404033 Ry ewald contribution = 4.03683718 Ry convergence has been achieved in 5 iterations Writing output data file sih4.save init_run : 2.00s CPU 2.04s WALL ( 1 calls) electrons : 10.67s CPU 10.87s WALL ( 1 calls) Called by init_run: wfcinit : 0.05s CPU 0.05s WALL ( 1 calls) potinit : 0.61s CPU 0.62s WALL ( 1 calls) Called by electrons: c_bands : 0.39s CPU 0.40s WALL ( 5 calls) sum_band : 3.65s CPU 3.70s WALL ( 5 calls) v_of_rho : 2.55s CPU 2.63s WALL ( 6 calls) newd : 4.24s CPU 4.28s WALL ( 6 calls) mix_rho : 0.34s CPU 0.34s WALL ( 5 calls) Called by c_bands: init_us_2 : 0.01s CPU 0.01s WALL ( 11 calls) regterg : 0.36s CPU 0.37s WALL ( 5 calls) Called by *egterg: h_psi : 0.40s CPU 0.40s WALL ( 16 calls) s_psi : 0.00s CPU 0.00s WALL ( 16 calls) g_psi : 0.00s CPU 0.00s WALL ( 10 calls) rdiaghg : 0.00s CPU 0.00s WALL ( 15 calls) Called by h_psi: add_vuspsi : 0.00s CPU 0.00s WALL ( 16 calls) General routines calbec : 0.01s CPU 0.01s WALL ( 21 calls) fft : 3.08s CPU 3.12s WALL ( 92 calls) ffts : 0.07s CPU 0.07s WALL ( 11 calls) fftw : 0.39s CPU 0.39s WALL ( 74 calls) interpolate : 0.46s CPU 0.47s WALL ( 11 calls) davcio : 0.00s CPU 0.00s WALL ( 5 calls) Parallel routines fft_scatter : 1.20s CPU 1.22s WALL ( 177 calls) PWSCF : 12.91s CPU 13.27s WALL This run was terminated on: 11:54:27 12Jan2012 =------------------------------------------------------------------------------= JOB DONE. =------------------------------------------------------------------------------= TDDFPT/Examples/SiH4/SiH4.tddfpt_pp-in0000644000175000017500000000025112341371500015523 0ustar mbamba&lr_input prefix='sih4', outdir='./out', itermax=10000 itermax0=450 extrapolation="osc" epsil=0.01 end=3.50d0 increment=0.001d0 start=0.0d0 ipol=4 / TDDFPT/Examples/SiH4/SiH4.pw-in0000644000175000017500000000125412341371500014171 0ustar mbamba&control calculation = 'scf' title = 'TDDFPT Example SiH4 (US PPS)' restart_mode='from_scratch', pseudo_dir = '../pseudo', outdir='./out', prefix='sih4' / &system ibrav = 1, celldm(1) = 18, nat = 5, ntyp = 2, ecutwfc = 25, ecutrho = 250, / &electrons / &ions / ATOMIC_SPECIES Si 1.00000 Si.pbe-n-van.UPF H 1.00000 H.pbe-van_ak.UPF ATOMIC_POSITIONS {Angstrom} Si 0.000000000 0.000000000 0.000000000 H 0.861984020 0.861984020 0.861984020 H -0.861984020 -0.861984020 0.861984020 H 0.861984020 -0.861984020 -0.861984020 H -0.861984020 0.861984020 -0.861984020 K_POINTS {gamma} TDDFPT/Examples/SiH4/SiH4.tddfpt-st-in0000644000175000017500000000016212341371500015451 0ustar mbamba&lr_input prefix="sih4", outdir='./out', restart_step=250, / &lr_control itermax=5, ipol=1 / TDDFPT/Examples/SiH4/Makefile0000644000175000017500000000077612341371500014116 0ustar mbambainclude ../make.sys NAME = SiH4 default : all all : check_results check_results: $(NAME).pw-out $(NAME).tddfpt-out $(NAME).tddfpt_pp-out $(check_pw) $(NAME).pw-out $(NAME).pw-ref $(check_tddfpt) $(NAME).tddfpt-out $(NAME).tddfpt-ref small_test: $(NAME).pw-out $(NAME).tddfpt-st-out @$(check_pw) $(NAME).pw-out $(NAME).pw-ref @$(check_tddfpt) $(NAME).tddfpt-st-out $(NAME).tddfpt-st-ref clean : - /bin/rm -rf $(NAME).pw-out $(NAME).tddfpt-out $(NAME).tddfpt_pp-out $(NAME).tddfpt-st-out *.plot out/* TDDFPT/Examples/SiH4/SiH4.tddfpt-in0000644000175000017500000000016412341371500015027 0ustar mbamba&lr_input prefix="sih4", outdir='./out', restart_step=250, / &lr_control itermax=500, ipol=4 / TDDFPT/Examples/SiH4/SiH4.tddfpt-ref0000644000175000017500000247256612341371500015222 0ustar mbamba Program TDDFPT v.4.99 starts on 12Jan2012 at 12:15:15 This program is part of the open-source Quantum ESPRESSO suite for quantum simulation of materials; please cite "P. Giannozzi et al., J. Phys.:Condens. Matter 21 395502 (2009); URL http://www.quantum-espresso.org", in publications or presentations arising from this work. More details at http://www.quantum-espresso.org/quote.php Parallel version (MPI), running on 4 processors R & G space division: proc/pool = 4 ---------------------------------------- This is TDDFPT (Time Dependent Density Functional Perturbation Theory) Sub Version: 0.9 ---------------------------------------- Ultrasoft (Vanderbilt) Pseudopotentials Info: using nr1, nr2, nr3 values from input Info: using nr1s, nr2s, nr3s values from input IMPORTANT: XC functional enforced from input : Exchange-correlation = SLA PW PBE PBE ( 1 4 3 4 0) EXX-fraction = 0.00 Any further DFT definition will be discarded Please, verify this is what you really want Parallelization info -------------------- sticks: dense smooth PW G-vecs: dense smooth PW Min 1614 646 161 97286 24570 3072 Max 1616 647 166 97292 24623 3074 Sum 6461 2585 657 389159 98385 12293 Tot 3231 1293 329 negative rho (up, down): 0.141E-02 0.000E+00 Subspace diagonalization in iterative solution of the eigenvalue problem: a serial algorithm will be used Lanczos linear response spectrum calculation Number of Lanczos iterations = 500 Gamma point algorithm lr_wfcinit_spectrum: finished lr_solve_e Norm of initial Lanczos vectors= 2.201242292234776 Starting Lanczos loop 1 Lanczos iteration: 1 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal alpha(00000001)=0.000000000000000E+00 beta (00000002)=0.139836574130471E+01 gamma(00000002)=0.139836574130471E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 2 z1= 1 0.141271388852883E+01 0.000000000000000E+00 z1= 2 0.935133948873346E-06 0.000000000000000E+00 z1= 3 -.105432073780666E-05 0.000000000000000E+00 alpha(00000002)=0.000000000000000E+00 beta (00000003)=0.583916600557335E+01 gamma(00000003)=0.583916600557335E+01 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 3 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000003)=0.000000000000000E+00 beta (00000004)=0.140885952964573E+02 gamma(00000004)=0.140885952964573E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 4 z1= 1 -.471987988764546E+00 0.000000000000000E+00 z1= 2 -.664253088370620E-06 0.000000000000000E+00 z1= 3 0.357153146324707E-06 0.000000000000000E+00 alpha(00000004)=0.000000000000000E+00 beta (00000005)=0.136313166156627E+02 gamma(00000005)=0.136313166156627E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 5 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000005)=0.000000000000000E+00 beta (00000006)=0.120975960400089E+02 gamma(00000006)=0.120975960400089E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 6 z1= 1 0.472273577158524E+00 0.000000000000000E+00 z1= 2 0.940271949342875E-06 0.000000000000000E+00 z1= 3 -.271266101539063E-06 0.000000000000000E+00 alpha(00000006)=0.000000000000000E+00 beta (00000007)=0.129754021653103E+02 gamma(00000007)=0.129754021653103E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 7 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000007)=0.000000000000000E+00 beta (00000008)=0.137658013550881E+02 gamma(00000008)=0.137658013550881E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 8 z1= 1 -.420319918283641E+00 0.000000000000000E+00 z1= 2 -.103833061512390E-05 0.000000000000000E+00 z1= 3 0.882610744843814E-07 0.000000000000000E+00 alpha(00000008)=0.000000000000000E+00 beta (00000009)=0.114975053795275E+02 gamma(00000009)=0.114975053795275E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 9 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000009)=0.000000000000000E+00 beta (00000010)=0.144405194357833E+02 gamma(00000010)=0.144405194357833E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 10 z1= 1 0.320382549638844E+00 0.000000000000000E+00 z1= 2 0.903432436086954E-06 0.000000000000000E+00 z1= 3 0.458995897366365E-07 0.000000000000000E+00 alpha(00000010)=0.000000000000000E+00 beta (00000011)=0.114836215650978E+02 gamma(00000011)=0.114836215650978E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 11 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000011)=0.000000000000000E+00 beta (00000012)=0.141509918544947E+02 gamma(00000012)=0.141509918544947E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 12 z1= 1 -.249510946010455E+00 0.000000000000000E+00 z1= 2 -.805029757039270E-06 0.000000000000000E+00 z1= 3 -.302455189490902E-06 0.000000000000000E+00 alpha(00000012)=0.000000000000000E+00 beta (00000013)=0.121762183280158E+02 gamma(00000013)=0.121762183280158E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 13 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000013)=0.000000000000000E+00 beta (00000014)=0.136922039129698E+02 gamma(00000014)=0.136922039129698E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 14 z1= 1 0.214067283342898E+00 0.000000000000000E+00 z1= 2 0.709993671855515E-06 0.000000000000000E+00 z1= 3 0.305501537949115E-06 0.000000000000000E+00 alpha(00000014)=0.000000000000000E+00 beta (00000015)=0.126056539735133E+02 gamma(00000015)=0.126056539735133E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 15 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000015)=0.000000000000000E+00 beta (00000016)=0.132628497294811E+02 gamma(00000016)=0.132628497294811E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 16 z1= 1 -.197585849506369E+00 0.000000000000000E+00 z1= 2 -.698613852579376E-06 0.000000000000000E+00 z1= 3 -.401839885276153E-06 0.000000000000000E+00 alpha(00000016)=0.000000000000000E+00 beta (00000017)=0.126324766945476E+02 gamma(00000017)=0.126324766945476E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 17 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000017)=0.000000000000000E+00 beta (00000018)=0.132917574044304E+02 gamma(00000018)=0.132917574044304E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 18 z1= 1 0.183443648643846E+00 0.000000000000000E+00 z1= 2 0.816053382391227E-06 0.000000000000000E+00 z1= 3 0.348748355666340E-06 0.000000000000000E+00 alpha(00000018)=0.000000000000000E+00 beta (00000019)=0.125780970112194E+02 gamma(00000019)=0.125780970112194E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 19 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000019)=0.000000000000000E+00 beta (00000020)=0.133265870618805E+02 gamma(00000020)=0.133265870618805E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 20 z1= 1 -.169454418365915E+00 0.000000000000000E+00 z1= 2 -.500243738033729E-06 0.000000000000000E+00 z1= 3 -.286901248680235E-06 0.000000000000000E+00 alpha(00000020)=0.000000000000000E+00 beta (00000021)=0.126804583436830E+02 gamma(00000021)=0.126804583436830E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 21 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000021)=0.000000000000000E+00 beta (00000022)=0.135268764390412E+02 gamma(00000022)=0.135268764390412E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 22 z1= 1 0.155557281767789E+00 0.000000000000000E+00 z1= 2 0.784063365925555E-06 0.000000000000000E+00 z1= 3 -.152517721737451E-06 0.000000000000000E+00 alpha(00000022)=0.000000000000000E+00 beta (00000023)=0.127977238369354E+02 gamma(00000023)=0.127977238369354E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 23 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000023)=0.000000000000000E+00 beta (00000024)=0.129393259492176E+02 gamma(00000024)=0.129393259492176E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 24 z1= 1 -.150679307554255E+00 0.000000000000000E+00 z1= 2 -.123168100393811E-05 0.000000000000000E+00 z1= 3 0.235117343571397E-06 0.000000000000000E+00 alpha(00000024)=0.000000000000000E+00 beta (00000025)=0.127073988699077E+02 gamma(00000025)=0.127073988699077E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 25 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000025)=0.000000000000000E+00 beta (00000026)=0.128587610381685E+02 gamma(00000026)=0.128587610381685E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 26 z1= 1 0.146077434851461E+00 0.000000000000000E+00 z1= 2 0.436263228606806E-06 0.000000000000000E+00 z1= 3 -.494677701610947E-06 0.000000000000000E+00 alpha(00000026)=0.000000000000000E+00 beta (00000027)=0.129459357850530E+02 gamma(00000027)=0.129459357850530E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 27 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000027)=0.000000000000000E+00 beta (00000028)=0.129316400288109E+02 gamma(00000028)=0.129316400288109E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 28 z1= 1 -.143972613705983E+00 0.000000000000000E+00 z1= 2 -.749069995319845E-06 0.000000000000000E+00 z1= 3 0.856859438484823E-06 0.000000000000000E+00 alpha(00000028)=0.000000000000000E+00 beta (00000029)=0.128384071646316E+02 gamma(00000029)=0.128384071646316E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 29 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000029)=0.000000000000000E+00 beta (00000030)=0.131776058001248E+02 gamma(00000030)=0.131776058001248E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 30 z1= 1 0.138441288737094E+00 0.000000000000000E+00 z1= 2 0.183201577222750E-05 0.000000000000000E+00 z1= 3 -.915245359433604E-06 0.000000000000000E+00 alpha(00000030)=0.000000000000000E+00 beta (00000031)=0.126979034380974E+02 gamma(00000031)=0.126979034380974E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 31 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000031)=0.000000000000000E+00 beta (00000032)=0.131550931698993E+02 gamma(00000032)=0.131550931698993E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 32 z1= 1 -.132127547510673E+00 0.000000000000000E+00 z1= 2 -.109915975435738E-05 0.000000000000000E+00 z1= 3 0.113613494921727E-05 0.000000000000000E+00 alpha(00000032)=0.000000000000000E+00 beta (00000033)=0.123726254905416E+02 gamma(00000033)=0.123726254905416E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 33 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000033)=0.000000000000000E+00 beta (00000034)=0.135230970849385E+02 gamma(00000034)=0.135230970849385E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 34 z1= 1 0.119594965006268E+00 0.000000000000000E+00 z1= 2 0.915974971001272E-06 0.000000000000000E+00 z1= 3 -.663634024952037E-06 0.000000000000000E+00 alpha(00000034)=0.000000000000000E+00 beta (00000035)=0.123513281836141E+02 gamma(00000035)=0.123513281836141E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 35 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000035)=0.000000000000000E+00 beta (00000036)=0.131884003374896E+02 gamma(00000036)=0.131884003374896E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 36 z1= 1 -.110744292576114E+00 0.000000000000000E+00 z1= 2 -.161652688567080E-05 0.000000000000000E+00 z1= 3 0.159826111619031E-05 0.000000000000000E+00 alpha(00000036)=0.000000000000000E+00 beta (00000037)=0.124681211105778E+02 gamma(00000037)=0.124681211105778E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 37 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000037)=0.000000000000000E+00 beta (00000038)=0.132930546545601E+02 gamma(00000038)=0.132930546545601E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 38 z1= 1 0.102624066107309E+00 0.000000000000000E+00 z1= 2 0.254536782078908E-05 0.000000000000000E+00 z1= 3 -.158570134017075E-05 0.000000000000000E+00 alpha(00000038)=0.000000000000000E+00 beta (00000039)=0.129486000174378E+02 gamma(00000039)=0.129486000174378E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 39 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000039)=0.000000000000000E+00 beta (00000040)=0.132358528246725E+02 gamma(00000040)=0.132358528246725E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 40 z1= 1 -.992517675126113E-01 0.000000000000000E+00 z1= 2 -.267498448964284E-05 0.000000000000000E+00 z1= 3 0.928547651930290E-06 0.000000000000000E+00 alpha(00000040)=0.000000000000000E+00 beta (00000041)=0.128332674172985E+02 gamma(00000041)=0.128332674172985E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 41 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000041)=0.000000000000000E+00 beta (00000042)=0.126752061454622E+02 gamma(00000042)=0.126752061454622E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 42 z1= 1 0.992972866468386E-01 0.000000000000000E+00 z1= 2 0.292409354495701E-05 0.000000000000000E+00 z1= 3 -.519411033256733E-06 0.000000000000000E+00 alpha(00000042)=0.000000000000000E+00 beta (00000043)=0.129621774109171E+02 gamma(00000043)=0.129621774109171E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 43 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000043)=0.000000000000000E+00 beta (00000044)=0.130762159397691E+02 gamma(00000044)=0.130762159397691E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 44 z1= 1 -.973431978592481E-01 0.000000000000000E+00 z1= 2 -.280226049131221E-05 0.000000000000000E+00 z1= 3 0.102958018160723E-05 0.000000000000000E+00 alpha(00000044)=0.000000000000000E+00 beta (00000045)=0.128720673322138E+02 gamma(00000045)=0.128720673322138E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 45 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000045)=0.000000000000000E+00 beta (00000046)=0.131384679756663E+02 gamma(00000046)=0.131384679756663E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 46 z1= 1 0.944322234059498E-01 0.000000000000000E+00 z1= 2 0.342142557092223E-05 0.000000000000000E+00 z1= 3 -.128674822968229E-05 0.000000000000000E+00 alpha(00000046)=0.000000000000000E+00 beta (00000047)=0.124675128877747E+02 gamma(00000047)=0.124675128877747E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 47 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000047)=0.000000000000000E+00 beta (00000048)=0.132107261401883E+02 gamma(00000048)=0.132107261401883E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 48 z1= 1 -.886315407507240E-01 0.000000000000000E+00 z1= 2 -.440025757297499E-05 0.000000000000000E+00 z1= 3 0.629743782797542E-06 0.000000000000000E+00 alpha(00000048)=0.000000000000000E+00 beta (00000049)=0.125330699189945E+02 gamma(00000049)=0.125330699189945E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 49 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000049)=0.000000000000000E+00 beta (00000050)=0.134282094939915E+02 gamma(00000050)=0.134282094939915E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 50 z1= 1 0.826275868199079E-01 0.000000000000000E+00 z1= 2 0.419498823032473E-05 0.000000000000000E+00 z1= 3 -.629296246147117E-06 0.000000000000000E+00 alpha(00000050)=0.000000000000000E+00 beta (00000051)=0.125076031962570E+02 gamma(00000051)=0.125076031962570E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 51 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000051)=0.000000000000000E+00 beta (00000052)=0.134309991475983E+02 gamma(00000052)=0.134309991475983E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 52 z1= 1 -.771493423833629E-01 0.000000000000000E+00 z1= 2 -.406172004258857E-05 0.000000000000000E+00 z1= 3 0.620412725164162E-06 0.000000000000000E+00 alpha(00000052)=0.000000000000000E+00 beta (00000053)=0.124676927071267E+02 gamma(00000053)=0.124676927071267E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 53 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000053)=0.000000000000000E+00 beta (00000054)=0.133578639655606E+02 gamma(00000054)=0.133578639655606E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 54 z1= 1 0.722921722873487E-01 0.000000000000000E+00 z1= 2 0.255438364159082E-05 0.000000000000000E+00 z1= 3 -.119959530735009E-06 0.000000000000000E+00 alpha(00000054)=0.000000000000000E+00 beta (00000055)=0.126451067273422E+02 gamma(00000055)=0.126451067273422E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 55 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000055)=0.000000000000000E+00 beta (00000056)=0.128792000538440E+02 gamma(00000056)=0.128792000538440E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 56 z1= 1 -.716193218128740E-01 0.000000000000000E+00 z1= 2 -.209685581822969E-05 0.000000000000000E+00 z1= 3 0.302240178136478E-06 0.000000000000000E+00 alpha(00000056)=0.000000000000000E+00 beta (00000057)=0.127414427882006E+02 gamma(00000057)=0.127414427882006E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 57 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000057)=0.000000000000000E+00 beta (00000058)=0.132233068146290E+02 gamma(00000058)=0.132233068146290E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 58 z1= 1 0.698257940208786E-01 0.000000000000000E+00 z1= 2 0.196450299041855E-05 0.000000000000000E+00 z1= 3 -.359147874068257E-06 0.000000000000000E+00 alpha(00000058)=0.000000000000000E+00 beta (00000059)=0.127525016639498E+02 gamma(00000059)=0.127525016639498E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 59 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000059)=0.000000000000000E+00 beta (00000060)=0.129596048119613E+02 gamma(00000060)=0.129596048119613E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 60 z1= 1 -.698232304180831E-01 0.000000000000000E+00 z1= 2 -.182362771474973E-05 0.000000000000000E+00 z1= 3 0.152384888172497E-05 0.000000000000000E+00 alpha(00000060)=0.000000000000000E+00 beta (00000061)=0.128509777882862E+02 gamma(00000061)=0.128509777882862E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 61 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000061)=0.000000000000000E+00 beta (00000062)=0.133872190234621E+02 gamma(00000062)=0.133872190234621E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 62 z1= 1 0.679675072285452E-01 0.000000000000000E+00 z1= 2 0.106802298786499E-05 0.000000000000000E+00 z1= 3 -.139376323681352E-05 0.000000000000000E+00 alpha(00000062)=0.000000000000000E+00 beta (00000063)=0.126331463602039E+02 gamma(00000063)=0.126331463602039E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 63 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000063)=0.000000000000000E+00 beta (00000064)=0.133859242778912E+02 gamma(00000064)=0.133859242778912E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 64 z1= 1 -.648286803025631E-01 0.000000000000000E+00 z1= 2 -.186857991177087E-05 0.000000000000000E+00 z1= 3 0.570730162004565E-06 0.000000000000000E+00 alpha(00000064)=0.000000000000000E+00 beta (00000065)=0.121789264845405E+02 gamma(00000065)=0.121789264845405E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 65 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000065)=0.000000000000000E+00 beta (00000066)=0.133448458718557E+02 gamma(00000066)=0.133448458718557E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 66 z1= 1 0.593016063022537E-01 0.000000000000000E+00 z1= 2 0.308480969715436E-05 0.000000000000000E+00 z1= 3 -.831775338978993E-06 0.000000000000000E+00 alpha(00000066)=0.000000000000000E+00 beta (00000067)=0.126993890438754E+02 gamma(00000067)=0.126993890438754E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 67 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000067)=0.000000000000000E+00 beta (00000068)=0.131872845040518E+02 gamma(00000068)=0.131872845040518E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 68 z1= 1 -.564711028602000E-01 0.000000000000000E+00 z1= 2 -.234875016857277E-05 0.000000000000000E+00 z1= 3 0.127614030295635E-05 0.000000000000000E+00 alpha(00000068)=0.000000000000000E+00 beta (00000069)=0.126620509656180E+02 gamma(00000069)=0.126620509656180E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 69 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000069)=0.000000000000000E+00 beta (00000070)=0.133212219304134E+02 gamma(00000070)=0.133212219304134E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 70 z1= 1 0.525108040003196E-01 0.000000000000000E+00 z1= 2 0.312241704598817E-05 0.000000000000000E+00 z1= 3 -.140035179713684E-05 0.000000000000000E+00 alpha(00000070)=0.000000000000000E+00 beta (00000071)=0.126538336415140E+02 gamma(00000071)=0.126538336415140E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 71 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000071)=0.000000000000000E+00 beta (00000072)=0.132711279401299E+02 gamma(00000072)=0.132711279401299E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 72 z1= 1 -.485791467353040E-01 0.000000000000000E+00 z1= 2 -.314662720447096E-05 0.000000000000000E+00 z1= 3 0.211122393735142E-05 0.000000000000000E+00 alpha(00000072)=0.000000000000000E+00 beta (00000073)=0.126963357119804E+02 gamma(00000073)=0.126963357119804E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 73 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000073)=0.000000000000000E+00 beta (00000074)=0.130222488549599E+02 gamma(00000074)=0.130222488549599E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 74 z1= 1 0.455367910425978E-01 0.000000000000000E+00 z1= 2 0.391809267386283E-05 0.000000000000000E+00 z1= 3 -.172076678883580E-05 0.000000000000000E+00 alpha(00000074)=0.000000000000000E+00 beta (00000075)=0.128779931146339E+02 gamma(00000075)=0.128779931146339E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 75 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000075)=0.000000000000000E+00 beta (00000076)=0.132610902792588E+02 gamma(00000076)=0.132610902792588E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 76 z1= 1 -.425265899995774E-01 0.000000000000000E+00 z1= 2 -.454998301379489E-05 0.000000000000000E+00 z1= 3 0.138229320210641E-05 0.000000000000000E+00 alpha(00000076)=0.000000000000000E+00 beta (00000077)=0.127609826638958E+02 gamma(00000077)=0.127609826638958E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 77 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000077)=0.000000000000000E+00 beta (00000078)=0.131376552912698E+02 gamma(00000078)=0.131376552912698E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 78 z1= 1 0.395215998634452E-01 0.000000000000000E+00 z1= 2 0.535596496525209E-05 0.000000000000000E+00 z1= 3 -.176851345541488E-05 0.000000000000000E+00 alpha(00000078)=0.000000000000000E+00 beta (00000079)=0.128833071131824E+02 gamma(00000079)=0.128833071131824E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 79 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000079)=0.000000000000000E+00 beta (00000080)=0.127681877589701E+02 gamma(00000080)=0.127681877589701E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 80 z1= 1 -.383987172187567E-01 0.000000000000000E+00 z1= 2 -.857282971365725E-05 0.000000000000000E+00 z1= 3 0.307886913824784E-05 0.000000000000000E+00 alpha(00000080)=0.000000000000000E+00 beta (00000081)=0.129708594729951E+02 gamma(00000081)=0.129708594729951E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 81 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000081)=0.000000000000000E+00 beta (00000082)=0.131224690856857E+02 gamma(00000082)=0.131224690856857E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 82 z1= 1 0.369271436233338E-01 0.000000000000000E+00 z1= 2 0.109444262898772E-04 0.000000000000000E+00 z1= 3 -.254996815694320E-05 0.000000000000000E+00 alpha(00000082)=0.000000000000000E+00 beta (00000083)=0.126065933666429E+02 gamma(00000083)=0.126065933666429E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 83 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000083)=0.000000000000000E+00 beta (00000084)=0.134494830805704E+02 gamma(00000084)=0.134494830805704E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 84 z1= 1 -.338007015574220E-01 0.000000000000000E+00 z1= 2 -.118839087258661E-04 0.000000000000000E+00 z1= 3 0.117451422572889E-05 0.000000000000000E+00 alpha(00000084)=0.000000000000000E+00 beta (00000085)=0.123889677344780E+02 gamma(00000085)=0.123889677344780E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 85 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000085)=0.000000000000000E+00 beta (00000086)=0.132662183514345E+02 gamma(00000086)=0.132662183514345E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 86 z1= 1 0.309269665289884E-01 0.000000000000000E+00 z1= 2 0.127870814604775E-04 0.000000000000000E+00 z1= 3 -.121558520292534E-05 0.000000000000000E+00 alpha(00000086)=0.000000000000000E+00 beta (00000087)=0.124219266563940E+02 gamma(00000087)=0.124219266563940E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 87 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000087)=0.000000000000000E+00 beta (00000088)=0.132435575796132E+02 gamma(00000088)=0.132435575796132E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 88 z1= 1 -.286490017020080E-01 0.000000000000000E+00 z1= 2 -.138222408722329E-04 0.000000000000000E+00 z1= 3 0.227259166644695E-05 0.000000000000000E+00 alpha(00000088)=0.000000000000000E+00 beta (00000089)=0.125378705161854E+02 gamma(00000089)=0.125378705161854E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 89 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000089)=0.000000000000000E+00 beta (00000090)=0.133107638483543E+02 gamma(00000090)=0.133107638483543E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 90 z1= 1 0.269247237792343E-01 0.000000000000000E+00 z1= 2 0.148167445458867E-04 0.000000000000000E+00 z1= 3 -.242368953006921E-05 0.000000000000000E+00 alpha(00000090)=0.000000000000000E+00 beta (00000091)=0.126843979033932E+02 gamma(00000091)=0.126843979033932E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 91 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000091)=0.000000000000000E+00 beta (00000092)=0.131704917680058E+02 gamma(00000092)=0.131704917680058E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 92 z1= 1 -.258035160339195E-01 0.000000000000000E+00 z1= 2 -.173552652363066E-04 0.000000000000000E+00 z1= 3 0.188382990511869E-05 0.000000000000000E+00 alpha(00000092)=0.000000000000000E+00 beta (00000093)=0.128551419933429E+02 gamma(00000093)=0.128551419933429E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 93 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000093)=0.000000000000000E+00 beta (00000094)=0.131658015845545E+02 gamma(00000094)=0.131658015845545E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 94 z1= 1 0.248357891962828E-01 0.000000000000000E+00 z1= 2 0.160333940887290E-04 0.000000000000000E+00 z1= 3 -.254630939446960E-05 0.000000000000000E+00 alpha(00000094)=0.000000000000000E+00 beta (00000095)=0.128086517436213E+02 gamma(00000095)=0.128086517436213E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 95 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000095)=0.000000000000000E+00 beta (00000096)=0.133488511711348E+02 gamma(00000096)=0.133488511711348E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 96 z1= 1 -.234654540308621E-01 0.000000000000000E+00 z1= 2 -.133449418159919E-04 0.000000000000000E+00 z1= 3 0.202743061791311E-05 0.000000000000000E+00 alpha(00000096)=0.000000000000000E+00 beta (00000097)=0.126799116909858E+02 gamma(00000097)=0.126799116909858E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 97 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000097)=0.000000000000000E+00 beta (00000098)=0.134665138055224E+02 gamma(00000098)=0.134665138055224E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 98 z1= 1 0.222290193315988E-01 0.000000000000000E+00 z1= 2 0.115945731405033E-04 0.000000000000000E+00 z1= 3 -.124789812151391E-05 0.000000000000000E+00 alpha(00000098)=0.000000000000000E+00 beta (00000099)=0.127341463162252E+02 gamma(00000099)=0.127341463162252E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 99 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000099)=0.000000000000000E+00 beta (00000100)=0.134446009819711E+02 gamma(00000100)=0.134446009819711E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 100 z1= 1 -.215346054628489E-01 0.000000000000000E+00 z1= 2 -.108203629203087E-04 0.000000000000000E+00 z1= 3 0.159891890163350E-05 0.000000000000000E+00 alpha(00000100)=0.000000000000000E+00 beta (00000101)=0.127411576937055E+02 gamma(00000101)=0.127411576937055E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 101 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000101)=0.000000000000000E+00 beta (00000102)=0.132557756686217E+02 gamma(00000102)=0.132557756686217E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 102 z1= 1 0.211585693912345E-01 0.000000000000000E+00 z1= 2 0.100684993662855E-04 0.000000000000000E+00 z1= 3 -.229392598923245E-05 0.000000000000000E+00 alpha(00000102)=0.000000000000000E+00 beta (00000103)=0.126952413337806E+02 gamma(00000103)=0.126952413337806E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 103 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000103)=0.000000000000000E+00 beta (00000104)=0.130549523895423E+02 gamma(00000104)=0.130549523895423E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 104 z1= 1 -.203933785947606E-01 0.000000000000000E+00 z1= 2 -.784919653957269E-05 0.000000000000000E+00 z1= 3 0.260669584279093E-05 0.000000000000000E+00 alpha(00000104)=0.000000000000000E+00 beta (00000105)=0.124338023769980E+02 gamma(00000105)=0.124338023769980E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 105 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000105)=0.000000000000000E+00 beta (00000106)=0.131210763281203E+02 gamma(00000106)=0.131210763281203E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 106 z1= 1 0.185560686926304E-01 0.000000000000000E+00 z1= 2 0.545473874316409E-05 0.000000000000000E+00 z1= 3 -.215277804281486E-05 0.000000000000000E+00 alpha(00000106)=0.000000000000000E+00 beta (00000107)=0.125418786772732E+02 gamma(00000107)=0.125418786772732E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 107 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000107)=0.000000000000000E+00 beta (00000108)=0.129509756426440E+02 gamma(00000108)=0.129509756426440E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 108 z1= 1 -.166564685115363E-01 0.000000000000000E+00 z1= 2 -.395221416893063E-05 0.000000000000000E+00 z1= 3 0.217805581235816E-05 0.000000000000000E+00 alpha(00000108)=0.000000000000000E+00 beta (00000109)=0.126576156901693E+02 gamma(00000109)=0.126576156901693E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 109 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000109)=0.000000000000000E+00 beta (00000110)=0.128521984060220E+02 gamma(00000110)=0.128521984060220E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 110 z1= 1 0.147703811920379E-01 0.000000000000000E+00 z1= 2 0.470033986157276E-05 0.000000000000000E+00 z1= 3 -.170923793238356E-05 0.000000000000000E+00 alpha(00000110)=0.000000000000000E+00 beta (00000111)=0.121377332110927E+02 gamma(00000111)=0.121377332110927E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 111 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000111)=0.000000000000000E+00 beta (00000112)=0.130626059302627E+02 gamma(00000112)=0.130626059302627E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 112 z1= 1 -.125306633551534E-01 0.000000000000000E+00 z1= 2 -.464997308094028E-05 0.000000000000000E+00 z1= 3 0.146396895803918E-05 0.000000000000000E+00 alpha(00000112)=0.000000000000000E+00 beta (00000113)=0.123827181436130E+02 gamma(00000113)=0.123827181436130E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 113 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000113)=0.000000000000000E+00 beta (00000114)=0.131500649811881E+02 gamma(00000114)=0.131500649811881E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 114 z1= 1 0.110224046971444E-01 0.000000000000000E+00 z1= 2 0.696661054909627E-05 0.000000000000000E+00 z1= 3 -.287688595422447E-05 0.000000000000000E+00 alpha(00000114)=0.000000000000000E+00 beta (00000115)=0.126761470766308E+02 gamma(00000115)=0.126761470766308E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 115 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000115)=0.000000000000000E+00 beta (00000116)=0.134862818505653E+02 gamma(00000116)=0.134862818505653E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 116 z1= 1 -.989110944154484E-02 0.000000000000000E+00 z1= 2 -.972296037648340E-05 0.000000000000000E+00 z1= 3 0.200067165258543E-05 0.000000000000000E+00 alpha(00000116)=0.000000000000000E+00 beta (00000117)=0.125983121249373E+02 gamma(00000117)=0.125983121249373E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 117 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000117)=0.000000000000000E+00 beta (00000118)=0.129690768369958E+02 gamma(00000118)=0.129690768369958E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 118 z1= 1 0.974721921832835E-02 0.000000000000000E+00 z1= 2 0.149643646295038E-04 0.000000000000000E+00 z1= 3 -.142048069925831E-05 0.000000000000000E+00 alpha(00000118)=0.000000000000000E+00 beta (00000119)=0.121785551900196E+02 gamma(00000119)=0.121785551900196E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 119 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000119)=0.000000000000000E+00 beta (00000120)=0.130010717959860E+02 gamma(00000120)=0.130010717959860E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 120 z1= 1 -.924832946851145E-02 0.000000000000000E+00 z1= 2 -.185268075821718E-04 0.000000000000000E+00 z1= 3 0.403884235265360E-06 0.000000000000000E+00 alpha(00000120)=0.000000000000000E+00 beta (00000121)=0.126742772575033E+02 gamma(00000121)=0.126742772575033E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 121 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000121)=0.000000000000000E+00 beta (00000122)=0.136872877755924E+02 gamma(00000122)=0.136872877755924E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 122 z1= 1 0.859463873601815E-02 0.000000000000000E+00 z1= 2 0.251531027777689E-04 0.000000000000000E+00 z1= 3 -.148627295245294E-05 0.000000000000000E+00 alpha(00000122)=0.000000000000000E+00 beta (00000123)=0.127025617111063E+02 gamma(00000123)=0.127025617111063E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 123 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000123)=0.000000000000000E+00 beta (00000124)=0.134150720286433E+02 gamma(00000124)=0.134150720286433E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 124 z1= 1 -.823876759443724E-02 0.000000000000000E+00 z1= 2 -.296688176347213E-04 0.000000000000000E+00 z1= 3 0.252678468376654E-05 0.000000000000000E+00 alpha(00000124)=0.000000000000000E+00 beta (00000125)=0.123032241451476E+02 gamma(00000125)=0.123032241451476E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 125 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000125)=0.000000000000000E+00 beta (00000126)=0.133199948826895E+02 gamma(00000126)=0.133199948826895E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 126 z1= 1 0.776970300283815E-02 0.000000000000000E+00 z1= 2 0.366633925107289E-04 0.000000000000000E+00 z1= 3 -.275665247345924E-05 0.000000000000000E+00 alpha(00000126)=0.000000000000000E+00 beta (00000127)=0.129198643337263E+02 gamma(00000127)=0.129198643337263E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 127 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000127)=0.000000000000000E+00 beta (00000128)=0.131942304078872E+02 gamma(00000128)=0.131942304078872E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 128 z1= 1 -.803511016538747E-02 0.000000000000000E+00 z1= 2 -.448355703532724E-04 0.000000000000000E+00 z1= 3 -.272591267449010E-07 0.000000000000000E+00 alpha(00000128)=0.000000000000000E+00 beta (00000129)=0.131953482834515E+02 gamma(00000129)=0.131953482834515E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 129 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000129)=0.000000000000000E+00 beta (00000130)=0.132247219436133E+02 gamma(00000130)=0.132247219436133E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 130 z1= 1 0.832744783593996E-02 0.000000000000000E+00 z1= 2 0.506148400617693E-04 0.000000000000000E+00 z1= 3 0.290376277306960E-06 0.000000000000000E+00 alpha(00000130)=0.000000000000000E+00 beta (00000131)=0.126034812685623E+02 gamma(00000131)=0.126034812685623E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 131 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000131)=0.000000000000000E+00 beta (00000132)=0.130370275294294E+02 gamma(00000132)=0.130370275294294E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 132 z1= 1 -.822940125352467E-02 0.000000000000000E+00 z1= 2 -.569347337853760E-04 0.000000000000000E+00 z1= 3 -.336427110642079E-06 0.000000000000000E+00 alpha(00000132)=0.000000000000000E+00 beta (00000133)=0.123217930332659E+02 gamma(00000133)=0.123217930332659E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 133 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000133)=0.000000000000000E+00 beta (00000134)=0.131100682966417E+02 gamma(00000134)=0.131100682966417E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 134 z1= 1 0.774202703496780E-02 0.000000000000000E+00 z1= 2 0.621282238204741E-04 0.000000000000000E+00 z1= 3 -.126080737258545E-06 0.000000000000000E+00 alpha(00000134)=0.000000000000000E+00 beta (00000135)=0.128059485042942E+02 gamma(00000135)=0.128059485042942E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 135 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000135)=0.000000000000000E+00 beta (00000136)=0.129380388027076E+02 gamma(00000136)=0.129380388027076E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 136 z1= 1 -.768416189425788E-02 0.000000000000000E+00 z1= 2 -.700036806810279E-04 0.000000000000000E+00 z1= 3 0.303890714204217E-06 0.000000000000000E+00 alpha(00000136)=0.000000000000000E+00 beta (00000137)=0.133676281498954E+02 gamma(00000137)=0.133676281498954E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 137 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000137)=0.000000000000000E+00 beta (00000138)=0.131135518799891E+02 gamma(00000138)=0.131135518799891E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 138 z1= 1 0.813853086846866E-02 0.000000000000000E+00 z1= 2 0.749302611171548E-04 0.000000000000000E+00 z1= 3 -.192764751862356E-05 0.000000000000000E+00 alpha(00000138)=0.000000000000000E+00 beta (00000139)=0.128249472375553E+02 gamma(00000139)=0.128249472375553E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 139 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000139)=0.000000000000000E+00 beta (00000140)=0.128661040509560E+02 gamma(00000140)=0.128661040509560E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 140 z1= 1 -.835237263246913E-02 0.000000000000000E+00 z1= 2 -.794778949257660E-04 0.000000000000000E+00 z1= 3 0.308002393469183E-05 0.000000000000000E+00 alpha(00000140)=0.000000000000000E+00 beta (00000141)=0.127852234344257E+02 gamma(00000141)=0.127852234344257E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 141 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000141)=0.000000000000000E+00 beta (00000142)=0.129512204278136E+02 gamma(00000142)=0.129512204278136E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 142 z1= 1 0.801262347346329E-02 0.000000000000000E+00 z1= 2 0.829147320146207E-04 0.000000000000000E+00 z1= 3 -.369460917236473E-05 0.000000000000000E+00 alpha(00000142)=0.000000000000000E+00 beta (00000143)=0.128297109292684E+02 gamma(00000143)=0.128297109292684E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 143 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000143)=0.000000000000000E+00 beta (00000144)=0.129896327253614E+02 gamma(00000144)=0.129896327253614E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 144 z1= 1 -.739071223973349E-02 0.000000000000000E+00 z1= 2 -.874475112704956E-04 0.000000000000000E+00 z1= 3 0.356189335281053E-05 0.000000000000000E+00 alpha(00000144)=0.000000000000000E+00 beta (00000145)=0.123293988612773E+02 gamma(00000145)=0.123293988612773E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 145 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000145)=0.000000000000000E+00 beta (00000146)=0.131739754737275E+02 gamma(00000146)=0.131739754737275E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 146 z1= 1 0.614458813752704E-02 0.000000000000000E+00 z1= 2 0.896282274006031E-04 0.000000000000000E+00 z1= 3 -.324434309114917E-05 0.000000000000000E+00 alpha(00000146)=0.000000000000000E+00 beta (00000147)=0.126253950015814E+02 gamma(00000147)=0.126253950015814E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 147 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000147)=0.000000000000000E+00 beta (00000148)=0.130069588660788E+02 gamma(00000148)=0.130069588660788E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 148 z1= 1 -.549796972115255E-02 0.000000000000000E+00 z1= 2 -.926533520507053E-04 0.000000000000000E+00 z1= 3 0.467793071790655E-05 0.000000000000000E+00 alpha(00000148)=0.000000000000000E+00 beta (00000149)=0.129828041637770E+02 gamma(00000149)=0.129828041637770E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 149 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000149)=0.000000000000000E+00 beta (00000150)=0.132675790505497E+02 gamma(00000150)=0.132675790505497E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 150 z1= 1 0.561240455312563E-02 0.000000000000000E+00 z1= 2 0.969993430317223E-04 0.000000000000000E+00 z1= 3 -.434699742847520E-05 0.000000000000000E+00 alpha(00000150)=0.000000000000000E+00 beta (00000151)=0.129559551643079E+02 gamma(00000151)=0.129559551643079E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 151 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000151)=0.000000000000000E+00 beta (00000152)=0.129462910028103E+02 gamma(00000152)=0.129462910028103E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 152 z1= 1 -.630570425714758E-02 0.000000000000000E+00 z1= 2 -.104342743853057E-03 0.000000000000000E+00 z1= 3 0.192539531251558E-05 0.000000000000000E+00 alpha(00000152)=0.000000000000000E+00 beta (00000153)=0.128939691812128E+02 gamma(00000153)=0.128939691812128E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 153 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000153)=0.000000000000000E+00 beta (00000154)=0.130450289132491E+02 gamma(00000154)=0.130450289132491E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 154 z1= 1 0.702829856897412E-02 0.000000000000000E+00 z1= 2 0.111419365933832E-03 0.000000000000000E+00 z1= 3 0.104642046046277E-05 0.000000000000000E+00 alpha(00000154)=0.000000000000000E+00 beta (00000155)=0.128406403503694E+02 gamma(00000155)=0.128406403503694E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 155 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000155)=0.000000000000000E+00 beta (00000156)=0.130690561815689E+02 gamma(00000156)=0.130690561815689E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 156 z1= 1 -.776280110374858E-02 0.000000000000000E+00 z1= 2 -.114946633368989E-03 0.000000000000000E+00 z1= 3 -.165919650436426E-05 0.000000000000000E+00 alpha(00000156)=0.000000000000000E+00 beta (00000157)=0.122324944699412E+02 gamma(00000157)=0.122324944699412E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 157 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000157)=0.000000000000000E+00 beta (00000158)=0.135007705956885E+02 gamma(00000158)=0.135007705956885E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 158 z1= 1 0.794519557261017E-02 0.000000000000000E+00 z1= 2 0.109647126233889E-03 0.000000000000000E+00 z1= 3 0.268077253699929E-05 0.000000000000000E+00 alpha(00000158)=0.000000000000000E+00 beta (00000159)=0.122562581213263E+02 gamma(00000159)=0.122562581213263E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 159 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000159)=0.000000000000000E+00 beta (00000160)=0.132787558196690E+02 gamma(00000160)=0.132787558196690E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 160 z1= 1 -.849727387514781E-02 0.000000000000000E+00 z1= 2 -.106809176549687E-03 0.000000000000000E+00 z1= 3 -.678311289085981E-05 0.000000000000000E+00 alpha(00000160)=0.000000000000000E+00 beta (00000161)=0.125845320634701E+02 gamma(00000161)=0.125845320634701E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 161 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000161)=0.000000000000000E+00 beta (00000162)=0.130980737134730E+02 gamma(00000162)=0.130980737134730E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 162 z1= 1 0.938877883550347E-02 0.000000000000000E+00 z1= 2 0.108643632597978E-03 0.000000000000000E+00 z1= 3 0.860688472567332E-05 0.000000000000000E+00 alpha(00000162)=0.000000000000000E+00 beta (00000163)=0.128516415435644E+02 gamma(00000163)=0.128516415435644E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 163 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000163)=0.000000000000000E+00 beta (00000164)=0.128971873764820E+02 gamma(00000164)=0.128971873764820E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 164 z1= 1 -.103800367191496E-01 0.000000000000000E+00 z1= 2 -.113936089437505E-03 0.000000000000000E+00 z1= 3 -.124225516106685E-04 0.000000000000000E+00 alpha(00000164)=0.000000000000000E+00 beta (00000165)=0.127256006836820E+02 gamma(00000165)=0.127256006836820E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 165 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000165)=0.000000000000000E+00 beta (00000166)=0.132449533757579E+02 gamma(00000166)=0.132449533757579E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 166 z1= 1 0.107830834315753E-01 0.000000000000000E+00 z1= 2 0.111576579812991E-03 0.000000000000000E+00 z1= 3 0.144353392739110E-04 0.000000000000000E+00 alpha(00000166)=0.000000000000000E+00 beta (00000167)=0.129449124941674E+02 gamma(00000167)=0.129449124941674E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 167 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000167)=0.000000000000000E+00 beta (00000168)=0.133162919445134E+02 gamma(00000168)=0.133162919445134E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 168 z1= 1 -.112571800497046E-01 0.000000000000000E+00 z1= 2 -.111919023180687E-03 0.000000000000000E+00 z1= 3 -.145830575947228E-04 0.000000000000000E+00 alpha(00000168)=0.000000000000000E+00 beta (00000169)=0.125921366505253E+02 gamma(00000169)=0.125921366505253E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 169 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000169)=0.000000000000000E+00 beta (00000170)=0.133602438471797E+02 gamma(00000170)=0.133602438471797E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 170 z1= 1 0.113635940389755E-01 0.000000000000000E+00 z1= 2 0.113035071645735E-03 0.000000000000000E+00 z1= 3 0.139923674549131E-04 0.000000000000000E+00 alpha(00000170)=0.000000000000000E+00 beta (00000171)=0.125390916442189E+02 gamma(00000171)=0.125390916442189E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 171 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000171)=0.000000000000000E+00 beta (00000172)=0.131769864366462E+02 gamma(00000172)=0.131769864366462E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 172 z1= 1 -.112345088251378E-01 0.000000000000000E+00 z1= 2 -.114496450665800E-03 0.000000000000000E+00 z1= 3 -.133085634287969E-04 0.000000000000000E+00 alpha(00000172)=0.000000000000000E+00 beta (00000173)=0.125213458081756E+02 gamma(00000173)=0.125213458081756E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 173 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000173)=0.000000000000000E+00 beta (00000174)=0.126800632903843E+02 gamma(00000174)=0.126800632903843E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 174 z1= 1 0.111150179669350E-01 0.000000000000000E+00 z1= 2 0.121465170334303E-03 0.000000000000000E+00 z1= 3 0.112265355927668E-04 0.000000000000000E+00 alpha(00000174)=0.000000000000000E+00 beta (00000175)=0.126869121572565E+02 gamma(00000175)=0.126869121572565E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 175 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000175)=0.000000000000000E+00 beta (00000176)=0.131952667135890E+02 gamma(00000176)=0.131952667135890E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 176 z1= 1 -.102110728734367E-01 0.000000000000000E+00 z1= 2 -.122425264713686E-03 0.000000000000000E+00 z1= 3 -.802943436361550E-05 0.000000000000000E+00 alpha(00000176)=0.000000000000000E+00 beta (00000177)=0.129355752909708E+02 gamma(00000177)=0.129355752909708E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 177 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000177)=0.000000000000000E+00 beta (00000178)=0.131375441264357E+02 gamma(00000178)=0.131375441264357E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 178 z1= 1 0.969959527350912E-02 0.000000000000000E+00 z1= 2 0.127789178163544E-03 0.000000000000000E+00 z1= 3 0.642155237425121E-05 0.000000000000000E+00 alpha(00000178)=0.000000000000000E+00 beta (00000179)=0.127157386532836E+02 gamma(00000179)=0.127157386532836E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 179 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000179)=0.000000000000000E+00 beta (00000180)=0.134832170838669E+02 gamma(00000180)=0.134832170838669E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 180 z1= 1 -.922681286487137E-02 0.000000000000000E+00 z1= 2 -.129252144147616E-03 0.000000000000000E+00 z1= 3 -.370660840342749E-05 0.000000000000000E+00 alpha(00000180)=0.000000000000000E+00 beta (00000181)=0.126265260717091E+02 gamma(00000181)=0.126265260717091E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 181 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000181)=0.000000000000000E+00 beta (00000182)=0.131747005254314E+02 gamma(00000182)=0.131747005254314E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 182 z1= 1 0.922564850005199E-02 0.000000000000000E+00 z1= 2 0.132233411779405E-03 0.000000000000000E+00 z1= 3 0.496844313143080E-05 0.000000000000000E+00 alpha(00000182)=0.000000000000000E+00 beta (00000183)=0.125201278790440E+02 gamma(00000183)=0.125201278790440E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 183 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000183)=0.000000000000000E+00 beta (00000184)=0.132584321056582E+02 gamma(00000184)=0.132584321056582E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 184 z1= 1 -.925796850035732E-02 0.000000000000000E+00 z1= 2 -.134714484705081E-03 0.000000000000000E+00 z1= 3 -.195137091049279E-05 0.000000000000000E+00 alpha(00000184)=0.000000000000000E+00 beta (00000185)=0.126473797009941E+02 gamma(00000185)=0.126473797009941E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 185 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000185)=0.000000000000000E+00 beta (00000186)=0.135766169482094E+02 gamma(00000186)=0.135766169482094E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 186 z1= 1 0.901495090837480E-02 0.000000000000000E+00 z1= 2 0.131935334664072E-03 0.000000000000000E+00 z1= 3 0.167282782868351E-05 0.000000000000000E+00 alpha(00000186)=0.000000000000000E+00 beta (00000187)=0.130525904806101E+02 gamma(00000187)=0.130525904806101E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 187 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000187)=0.000000000000000E+00 beta (00000188)=0.129662525693887E+02 gamma(00000188)=0.129662525693887E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 188 z1= 1 -.943138051933267E-02 0.000000000000000E+00 z1= 2 -.144121041243018E-03 0.000000000000000E+00 z1= 3 -.100937571620831E-05 0.000000000000000E+00 alpha(00000188)=0.000000000000000E+00 beta (00000189)=0.127178887753312E+02 gamma(00000189)=0.127178887753312E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 189 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000189)=0.000000000000000E+00 beta (00000190)=0.131140230163399E+02 gamma(00000190)=0.131140230163399E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 190 z1= 1 0.950512104512254E-02 0.000000000000000E+00 z1= 2 0.147469485354542E-03 0.000000000000000E+00 z1= 3 0.416184960745885E-05 0.000000000000000E+00 alpha(00000190)=0.000000000000000E+00 beta (00000191)=0.126222743530470E+02 gamma(00000191)=0.126222743530470E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 191 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000191)=0.000000000000000E+00 beta (00000192)=0.132261247593412E+02 gamma(00000192)=0.132261247593412E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 192 z1= 1 -.925206793483839E-02 0.000000000000000E+00 z1= 2 -.151072584687594E-03 0.000000000000000E+00 z1= 3 -.241894112490632E-05 0.000000000000000E+00 alpha(00000192)=0.000000000000000E+00 beta (00000193)=0.124930454536915E+02 gamma(00000193)=0.124930454536915E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 193 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000193)=0.000000000000000E+00 beta (00000194)=0.131693964598446E+02 gamma(00000194)=0.131693964598446E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 194 z1= 1 0.862947012513297E-02 0.000000000000000E+00 z1= 2 0.151851125282760E-03 0.000000000000000E+00 z1= 3 0.235620414354974E-05 0.000000000000000E+00 alpha(00000194)=0.000000000000000E+00 beta (00000195)=0.124686533775749E+02 gamma(00000195)=0.124686533775749E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 195 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000195)=0.000000000000000E+00 beta (00000196)=0.132542324324311E+02 gamma(00000196)=0.132542324324311E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 196 z1= 1 -.785297366034692E-02 0.000000000000000E+00 z1= 2 -.152186714814439E-03 0.000000000000000E+00 z1= 3 -.325023786425845E-05 0.000000000000000E+00 alpha(00000196)=0.000000000000000E+00 beta (00000197)=0.119616155107228E+02 gamma(00000197)=0.119616155107228E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 197 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000197)=0.000000000000000E+00 beta (00000198)=0.130583155558787E+02 gamma(00000198)=0.130583155558787E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 198 z1= 1 0.739668676922955E-02 0.000000000000000E+00 z1= 2 0.148993064761524E-03 0.000000000000000E+00 z1= 3 0.436712012544401E-05 0.000000000000000E+00 alpha(00000198)=0.000000000000000E+00 beta (00000199)=0.127699151345958E+02 gamma(00000199)=0.127699151345958E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 199 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000199)=0.000000000000000E+00 beta (00000200)=0.131455422389923E+02 gamma(00000200)=0.131455422389923E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 200 z1= 1 -.796985562814040E-02 0.000000000000000E+00 z1= 2 -.150761171612980E-03 0.000000000000000E+00 z1= 3 -.418760169420494E-05 0.000000000000000E+00 alpha(00000200)=0.000000000000000E+00 beta (00000201)=0.128017107375429E+02 gamma(00000201)=0.128017107375429E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 201 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000201)=0.000000000000000E+00 beta (00000202)=0.132790372231307E+02 gamma(00000202)=0.132790372231307E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 202 z1= 1 0.872896815444652E-02 0.000000000000000E+00 z1= 2 0.153733584287714E-03 0.000000000000000E+00 z1= 3 0.250400052647433E-05 0.000000000000000E+00 alpha(00000202)=0.000000000000000E+00 beta (00000203)=0.128092286719259E+02 gamma(00000203)=0.128092286719259E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 203 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000203)=0.000000000000000E+00 beta (00000204)=0.128404991975130E+02 gamma(00000204)=0.128404991975130E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 204 z1= 1 -.937705840018580E-02 0.000000000000000E+00 z1= 2 -.157762228898219E-03 0.000000000000000E+00 z1= 3 0.205833393263777E-05 0.000000000000000E+00 alpha(00000204)=0.000000000000000E+00 beta (00000205)=0.124834828157122E+02 gamma(00000205)=0.124834828157122E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 205 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000205)=0.000000000000000E+00 beta (00000206)=0.131162512599199E+02 gamma(00000206)=0.131162512599199E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 206 z1= 1 0.917296799809808E-02 0.000000000000000E+00 z1= 2 0.157265155065367E-03 0.000000000000000E+00 z1= 3 -.558820903279818E-05 0.000000000000000E+00 alpha(00000206)=0.000000000000000E+00 beta (00000207)=0.128661508201067E+02 gamma(00000207)=0.128661508201067E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 207 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000207)=0.000000000000000E+00 beta (00000208)=0.130365227727692E+02 gamma(00000208)=0.130365227727692E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 208 z1= 1 -.871215908069640E-02 0.000000000000000E+00 z1= 2 -.161243008711600E-03 0.000000000000000E+00 z1= 3 0.651477481640851E-05 0.000000000000000E+00 alpha(00000208)=0.000000000000000E+00 beta (00000209)=0.128161369142933E+02 gamma(00000209)=0.128161369142933E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 209 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000209)=0.000000000000000E+00 beta (00000210)=0.136500354033331E+02 gamma(00000210)=0.136500354033331E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 210 z1= 1 0.755135006498004E-02 0.000000000000000E+00 z1= 2 0.156671995822887E-03 0.000000000000000E+00 z1= 3 -.761724266700305E-05 0.000000000000000E+00 alpha(00000210)=0.000000000000000E+00 beta (00000211)=0.130646687295172E+02 gamma(00000211)=0.130646687295172E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 211 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000211)=0.000000000000000E+00 beta (00000212)=0.130406508270676E+02 gamma(00000212)=0.130406508270676E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 212 z1= 1 -.709507604065589E-02 0.000000000000000E+00 z1= 2 -.161365247145752E-03 0.000000000000000E+00 z1= 3 0.998322605181754E-05 0.000000000000000E+00 alpha(00000212)=0.000000000000000E+00 beta (00000213)=0.125442141020534E+02 gamma(00000213)=0.125442141020534E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 213 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000213)=0.000000000000000E+00 beta (00000214)=0.134511091212348E+02 gamma(00000214)=0.134511091212348E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 214 z1= 1 0.638883471650598E-02 0.000000000000000E+00 z1= 2 0.159226368161219E-03 0.000000000000000E+00 z1= 3 -.103612584074404E-04 0.000000000000000E+00 alpha(00000214)=0.000000000000000E+00 beta (00000215)=0.126358523435266E+02 gamma(00000215)=0.126358523435266E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 215 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000215)=0.000000000000000E+00 beta (00000216)=0.130199934590807E+02 gamma(00000216)=0.130199934590807E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 216 z1= 1 -.622216189207358E-02 0.000000000000000E+00 z1= 2 -.159531359566551E-03 0.000000000000000E+00 z1= 3 0.103056137185094E-04 0.000000000000000E+00 alpha(00000216)=0.000000000000000E+00 beta (00000217)=0.132543342491700E+02 gamma(00000217)=0.132543342491700E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 217 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000217)=0.000000000000000E+00 beta (00000218)=0.130128282996327E+02 gamma(00000218)=0.130128282996327E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 218 z1= 1 0.620852521146501E-02 0.000000000000000E+00 z1= 2 0.166833752637686E-03 0.000000000000000E+00 z1= 3 -.103816878003540E-04 0.000000000000000E+00 alpha(00000218)=0.000000000000000E+00 beta (00000219)=0.122672566382839E+02 gamma(00000219)=0.122672566382839E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 219 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000219)=0.000000000000000E+00 beta (00000220)=0.131206152752158E+02 gamma(00000220)=0.131206152752158E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 220 z1= 1 -.587676202253553E-02 0.000000000000000E+00 z1= 2 -.159161613761810E-03 0.000000000000000E+00 z1= 3 0.107651763671913E-04 0.000000000000000E+00 alpha(00000220)=0.000000000000000E+00 beta (00000221)=0.118737415332265E+02 gamma(00000221)=0.118737415332265E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 221 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000221)=0.000000000000000E+00 beta (00000222)=0.131021522058762E+02 gamma(00000222)=0.131021522058762E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 222 z1= 1 0.565602433940524E-02 0.000000000000000E+00 z1= 2 0.147277187809242E-03 0.000000000000000E+00 z1= 3 -.764256646898427E-05 0.000000000000000E+00 alpha(00000222)=0.000000000000000E+00 beta (00000223)=0.127421477028233E+02 gamma(00000223)=0.127421477028233E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 223 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000223)=0.000000000000000E+00 beta (00000224)=0.138128005584959E+02 gamma(00000224)=0.138128005584959E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 224 z1= 1 -.531346910521098E-02 0.000000000000000E+00 z1= 2 -.139481809221972E-03 0.000000000000000E+00 z1= 3 0.486697725206857E-05 0.000000000000000E+00 alpha(00000224)=0.000000000000000E+00 beta (00000225)=0.125330053561176E+02 gamma(00000225)=0.125330053561176E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 225 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000225)=0.000000000000000E+00 beta (00000226)=0.128419768111524E+02 gamma(00000226)=0.128419768111524E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 226 z1= 1 0.478060360465025E-02 0.000000000000000E+00 z1= 2 0.142090062242101E-03 0.000000000000000E+00 z1= 3 -.263605779191804E-05 0.000000000000000E+00 alpha(00000226)=0.000000000000000E+00 beta (00000227)=0.125106256401683E+02 gamma(00000227)=0.125106256401683E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 227 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000227)=0.000000000000000E+00 beta (00000228)=0.128948548331825E+02 gamma(00000228)=0.128948548331825E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 228 z1= 1 -.381130267310263E-02 0.000000000000000E+00 z1= 2 -.136044590957020E-03 0.000000000000000E+00 z1= 3 0.116165641518399E-05 0.000000000000000E+00 alpha(00000228)=0.000000000000000E+00 beta (00000229)=0.125400807086652E+02 gamma(00000229)=0.125400807086652E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 229 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000229)=0.000000000000000E+00 beta (00000230)=0.130597558542602E+02 gamma(00000230)=0.130597558542602E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 230 z1= 1 0.308200516101526E-02 0.000000000000000E+00 z1= 2 0.129535551264603E-03 0.000000000000000E+00 z1= 3 0.312752007965470E-05 0.000000000000000E+00 alpha(00000230)=0.000000000000000E+00 beta (00000231)=0.128911414944441E+02 gamma(00000231)=0.128911414944441E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 231 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000231)=0.000000000000000E+00 beta (00000232)=0.137337276765090E+02 gamma(00000232)=0.137337276765090E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 232 z1= 1 -.261593636198700E-02 0.000000000000000E+00 z1= 2 -.124635156051243E-03 0.000000000000000E+00 z1= 3 -.742648780701618E-05 0.000000000000000E+00 alpha(00000232)=0.000000000000000E+00 beta (00000233)=0.126103920888585E+02 gamma(00000233)=0.126103920888585E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 233 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000233)=0.000000000000000E+00 beta (00000234)=0.134171663812254E+02 gamma(00000234)=0.134171663812254E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 234 z1= 1 0.237084979578307E-02 0.000000000000000E+00 z1= 2 0.116611349961345E-03 0.000000000000000E+00 z1= 3 0.104213398549419E-04 0.000000000000000E+00 alpha(00000234)=0.000000000000000E+00 beta (00000235)=0.128029636243063E+02 gamma(00000235)=0.128029636243063E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 235 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000235)=0.000000000000000E+00 beta (00000236)=0.127039379624495E+02 gamma(00000236)=0.127039379624495E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 236 z1= 1 -.227434363143274E-02 0.000000000000000E+00 z1= 2 -.114770410789309E-03 0.000000000000000E+00 z1= 3 -.116918380663364E-04 0.000000000000000E+00 alpha(00000236)=0.000000000000000E+00 beta (00000237)=0.123562759322595E+02 gamma(00000237)=0.123562759322595E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 237 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000237)=0.000000000000000E+00 beta (00000238)=0.136318099000316E+02 gamma(00000238)=0.136318099000316E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 238 z1= 1 0.172164426291659E-02 0.000000000000000E+00 z1= 2 0.981240496599860E-04 0.000000000000000E+00 z1= 3 0.122271027875009E-04 0.000000000000000E+00 alpha(00000238)=0.000000000000000E+00 beta (00000239)=0.128786819290389E+02 gamma(00000239)=0.128786819290389E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 239 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000239)=0.000000000000000E+00 beta (00000240)=0.138657928195926E+02 gamma(00000240)=0.138657928195926E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 240 z1= 1 -.118036955363207E-02 0.000000000000000E+00 z1= 2 -.868035388955114E-04 0.000000000000000E+00 z1= 3 -.164066294348075E-04 0.000000000000000E+00 alpha(00000240)=0.000000000000000E+00 beta (00000241)=0.127729899510617E+02 gamma(00000241)=0.127729899510617E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 241 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000241)=0.000000000000000E+00 beta (00000242)=0.133685030891012E+02 gamma(00000242)=0.133685030891012E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 242 z1= 1 0.892673633384384E-03 0.000000000000000E+00 z1= 2 0.826963736149343E-04 0.000000000000000E+00 z1= 3 0.177601241873631E-04 0.000000000000000E+00 alpha(00000242)=0.000000000000000E+00 beta (00000243)=0.120833105637344E+02 gamma(00000243)=0.120833105637344E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 243 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000243)=0.000000000000000E+00 beta (00000244)=0.133438316249041E+02 gamma(00000244)=0.133438316249041E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 244 z1= 1 -.820002037313384E-03 0.000000000000000E+00 z1= 2 -.719350002478213E-04 0.000000000000000E+00 z1= 3 -.233623913877851E-04 0.000000000000000E+00 alpha(00000244)=0.000000000000000E+00 beta (00000245)=0.123725606132753E+02 gamma(00000245)=0.123725606132753E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 245 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000245)=0.000000000000000E+00 beta (00000246)=0.132459492253533E+02 gamma(00000246)=0.132459492253533E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 246 z1= 1 0.809845201425174E-03 0.000000000000000E+00 z1= 2 0.651927020394634E-04 0.000000000000000E+00 z1= 3 0.228666597021050E-04 0.000000000000000E+00 alpha(00000246)=0.000000000000000E+00 beta (00000247)=0.124312657461999E+02 gamma(00000247)=0.124312657461999E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 247 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000247)=0.000000000000000E+00 beta (00000248)=0.131669653669983E+02 gamma(00000248)=0.131669653669983E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 248 z1= 1 -.925947270350939E-03 0.000000000000000E+00 z1= 2 -.555659257154388E-04 0.000000000000000E+00 z1= 3 -.247501427429974E-04 0.000000000000000E+00 alpha(00000248)=0.000000000000000E+00 beta (00000249)=0.128191001958349E+02 gamma(00000249)=0.128191001958349E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 249 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000249)=0.000000000000000E+00 beta (00000250)=0.130218022941426E+02 gamma(00000250)=0.130218022941426E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 250 z1= 1 0.146808105383368E-02 0.000000000000000E+00 z1= 2 0.608718839595380E-04 0.000000000000000E+00 z1= 3 0.262943207447925E-04 0.000000000000000E+00 alpha(00000250)=0.000000000000000E+00 beta (00000251)=0.124761179096565E+02 gamma(00000251)=0.124761179096565E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 251 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000251)=0.000000000000000E+00 beta (00000252)=0.130964604722528E+02 gamma(00000252)=0.130964604722528E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 252 z1= 1 -.235980954052507E-02 0.000000000000000E+00 z1= 2 -.537427148423857E-04 0.000000000000000E+00 z1= 3 -.286673184921875E-04 0.000000000000000E+00 alpha(00000252)=0.000000000000000E+00 beta (00000253)=0.119068176740522E+02 gamma(00000253)=0.119068176740522E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 253 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000253)=0.000000000000000E+00 beta (00000254)=0.132120514334195E+02 gamma(00000254)=0.132120514334195E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 254 z1= 1 0.340963494507466E-02 0.000000000000000E+00 z1= 2 0.558811877621052E-04 0.000000000000000E+00 z1= 3 0.269275420031373E-04 0.000000000000000E+00 alpha(00000254)=0.000000000000000E+00 beta (00000255)=0.124621936111665E+02 gamma(00000255)=0.124621936111665E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 255 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000255)=0.000000000000000E+00 beta (00000256)=0.133425951123989E+02 gamma(00000256)=0.133425951123989E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 256 z1= 1 -.450391128324003E-02 0.000000000000000E+00 z1= 2 -.477608687365228E-04 0.000000000000000E+00 z1= 3 -.250117617804290E-04 0.000000000000000E+00 alpha(00000256)=0.000000000000000E+00 beta (00000257)=0.126903719781199E+02 gamma(00000257)=0.126903719781199E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 257 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000257)=0.000000000000000E+00 beta (00000258)=0.128777132942476E+02 gamma(00000258)=0.128777132942476E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 258 z1= 1 0.556954907114836E-02 0.000000000000000E+00 z1= 2 0.519009318297008E-04 0.000000000000000E+00 z1= 3 0.229470852127534E-04 0.000000000000000E+00 alpha(00000258)=0.000000000000000E+00 beta (00000259)=0.125184403405527E+02 gamma(00000259)=0.125184403405527E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 259 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000259)=0.000000000000000E+00 beta (00000260)=0.131934551808471E+02 gamma(00000260)=0.131934551808471E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 260 z1= 1 -.594414824905659E-02 0.000000000000000E+00 z1= 2 -.418928900561485E-04 0.000000000000000E+00 z1= 3 -.218721906858266E-04 0.000000000000000E+00 alpha(00000260)=0.000000000000000E+00 beta (00000261)=0.122884552242841E+02 gamma(00000261)=0.122884552242841E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 261 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000261)=0.000000000000000E+00 beta (00000262)=0.137481499691718E+02 gamma(00000262)=0.137481499691718E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 262 z1= 1 0.530215030272216E-02 0.000000000000000E+00 z1= 2 0.428156597342801E-04 0.000000000000000E+00 z1= 3 0.190838171169608E-04 0.000000000000000E+00 alpha(00000262)=0.000000000000000E+00 beta (00000263)=0.126750066767040E+02 gamma(00000263)=0.126750066767040E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 263 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000263)=0.000000000000000E+00 beta (00000264)=0.130557403505526E+02 gamma(00000264)=0.130557403505526E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 264 z1= 1 -.469697705954004E-02 0.000000000000000E+00 z1= 2 -.297081803585131E-04 0.000000000000000E+00 z1= 3 -.160703279884173E-04 0.000000000000000E+00 alpha(00000264)=0.000000000000000E+00 beta (00000265)=0.129578157693651E+02 gamma(00000265)=0.129578157693651E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 265 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000265)=0.000000000000000E+00 beta (00000266)=0.133982222055340E+02 gamma(00000266)=0.133982222055340E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 266 z1= 1 0.398060324693879E-02 0.000000000000000E+00 z1= 2 0.314240969577989E-04 0.000000000000000E+00 z1= 3 0.144906488014924E-04 0.000000000000000E+00 alpha(00000266)=0.000000000000000E+00 beta (00000267)=0.124018669664807E+02 gamma(00000267)=0.124018669664807E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 267 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000267)=0.000000000000000E+00 beta (00000268)=0.131859602884957E+02 gamma(00000268)=0.131859602884957E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 268 z1= 1 -.341053789357481E-02 0.000000000000000E+00 z1= 2 -.174592277572428E-04 0.000000000000000E+00 z1= 3 -.107172135453787E-04 0.000000000000000E+00 alpha(00000268)=0.000000000000000E+00 beta (00000269)=0.119895988538898E+02 gamma(00000269)=0.119895988538898E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 269 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000269)=0.000000000000000E+00 beta (00000270)=0.130677120288074E+02 gamma(00000270)=0.130677120288074E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 270 z1= 1 0.327151686687326E-02 0.000000000000000E+00 z1= 2 0.101636049583765E-04 0.000000000000000E+00 z1= 3 0.112211558654549E-04 0.000000000000000E+00 alpha(00000270)=0.000000000000000E+00 beta (00000271)=0.130851837131860E+02 gamma(00000271)=0.130851837131860E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 271 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000271)=0.000000000000000E+00 beta (00000272)=0.134548610518048E+02 gamma(00000272)=0.134548610518048E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 272 z1= 1 -.351330787136516E-02 0.000000000000000E+00 z1= 2 -.331597107319434E-06 0.000000000000000E+00 z1= 3 -.353659045860993E-05 0.000000000000000E+00 alpha(00000272)=0.000000000000000E+00 beta (00000273)=0.125017648138030E+02 gamma(00000273)=0.125017648138030E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 273 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000273)=0.000000000000000E+00 beta (00000274)=0.126448066217354E+02 gamma(00000274)=0.126448066217354E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 274 z1= 1 0.395265808242494E-02 0.000000000000000E+00 z1= 2 -.136977568680439E-04 0.000000000000000E+00 z1= 3 0.557964498668561E-05 0.000000000000000E+00 alpha(00000274)=0.000000000000000E+00 beta (00000275)=0.127291970235652E+02 gamma(00000275)=0.127291970235652E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 275 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000275)=0.000000000000000E+00 beta (00000276)=0.131713510331471E+02 gamma(00000276)=0.131713510331471E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 276 z1= 1 -.431734536011120E-02 0.000000000000000E+00 z1= 2 0.175048440957878E-04 0.000000000000000E+00 z1= 3 0.240094868071331E-05 0.000000000000000E+00 alpha(00000276)=0.000000000000000E+00 beta (00000277)=0.131553257683672E+02 gamma(00000277)=0.131553257683672E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 277 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000277)=0.000000000000000E+00 beta (00000278)=0.130682328236246E+02 gamma(00000278)=0.130682328236246E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 278 z1= 1 0.474115197117589E-02 0.000000000000000E+00 z1= 2 -.319746210232369E-04 0.000000000000000E+00 z1= 3 0.522890001418370E-05 0.000000000000000E+00 alpha(00000278)=0.000000000000000E+00 beta (00000279)=0.126462894963490E+02 gamma(00000279)=0.126462894963490E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 279 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000279)=0.000000000000000E+00 beta (00000280)=0.135251336335831E+02 gamma(00000280)=0.135251336335831E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 280 z1= 1 -.503565597912145E-02 0.000000000000000E+00 z1= 2 0.286044025692711E-04 0.000000000000000E+00 z1= 3 0.763971007285713E-05 0.000000000000000E+00 alpha(00000280)=0.000000000000000E+00 beta (00000281)=0.126350761885887E+02 gamma(00000281)=0.126350761885887E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 281 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000281)=0.000000000000000E+00 beta (00000282)=0.132700488320762E+02 gamma(00000282)=0.132700488320762E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 282 z1= 1 0.574692383101115E-02 0.000000000000000E+00 z1= 2 -.448413140144432E-04 0.000000000000000E+00 z1= 3 -.160269611227830E-05 0.000000000000000E+00 alpha(00000282)=0.000000000000000E+00 beta (00000283)=0.121729498646880E+02 gamma(00000283)=0.121729498646880E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 283 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000283)=0.000000000000000E+00 beta (00000284)=0.135193797525892E+02 gamma(00000284)=0.135193797525892E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 284 z1= 1 -.631243786907712E-02 0.000000000000000E+00 z1= 2 0.361721011980058E-04 0.000000000000000E+00 z1= 3 0.863748691362924E-05 0.000000000000000E+00 alpha(00000284)=0.000000000000000E+00 beta (00000285)=0.126717168633094E+02 gamma(00000285)=0.126717168633094E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 285 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000285)=0.000000000000000E+00 beta (00000286)=0.134121592569897E+02 gamma(00000286)=0.134121592569897E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 286 z1= 1 0.707074258129174E-02 0.000000000000000E+00 z1= 2 -.475244585821846E-04 0.000000000000000E+00 z1= 3 -.827046702014554E-06 0.000000000000000E+00 alpha(00000286)=0.000000000000000E+00 beta (00000287)=0.120993832848581E+02 gamma(00000287)=0.120993832848581E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 287 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000287)=0.000000000000000E+00 beta (00000288)=0.134062716916968E+02 gamma(00000288)=0.134062716916968E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 288 z1= 1 -.718176544986839E-02 0.000000000000000E+00 z1= 2 0.402634723334558E-04 0.000000000000000E+00 z1= 3 0.363931660763393E-05 0.000000000000000E+00 alpha(00000288)=0.000000000000000E+00 beta (00000289)=0.124493715998621E+02 gamma(00000289)=0.124493715998621E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 289 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000289)=0.000000000000000E+00 beta (00000290)=0.134099863934020E+02 gamma(00000290)=0.134099863934020E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 290 z1= 1 0.746256006801334E-02 0.000000000000000E+00 z1= 2 -.556620977449802E-04 0.000000000000000E+00 z1= 3 0.367446461636736E-05 0.000000000000000E+00 alpha(00000290)=0.000000000000000E+00 beta (00000291)=0.127568219378530E+02 gamma(00000291)=0.127568219378530E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 291 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000291)=0.000000000000000E+00 beta (00000292)=0.130382150215877E+02 gamma(00000292)=0.130382150215877E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 292 z1= 1 -.801097874483647E-02 0.000000000000000E+00 z1= 2 0.532343112314530E-04 0.000000000000000E+00 z1= 3 -.336039774660247E-05 0.000000000000000E+00 alpha(00000292)=0.000000000000000E+00 beta (00000293)=0.130391663717868E+02 gamma(00000293)=0.130391663717868E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 293 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000293)=0.000000000000000E+00 beta (00000294)=0.134252328141242E+02 gamma(00000294)=0.134252328141242E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 294 z1= 1 0.835854522316363E-02 0.000000000000000E+00 z1= 2 -.644323415210975E-04 0.000000000000000E+00 z1= 3 0.106373860642072E-04 0.000000000000000E+00 alpha(00000294)=0.000000000000000E+00 beta (00000295)=0.123572510941924E+02 gamma(00000295)=0.123572510941924E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 295 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000295)=0.000000000000000E+00 beta (00000296)=0.136454197816580E+02 gamma(00000296)=0.136454197816580E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 296 z1= 1 -.823733999961189E-02 0.000000000000000E+00 z1= 2 0.583925912661125E-04 0.000000000000000E+00 z1= 3 -.159208833032577E-04 0.000000000000000E+00 alpha(00000296)=0.000000000000000E+00 beta (00000297)=0.124634948195301E+02 gamma(00000297)=0.124634948195301E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 297 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000297)=0.000000000000000E+00 beta (00000298)=0.133273437417304E+02 gamma(00000298)=0.133273437417304E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 298 z1= 1 0.846818222742707E-02 0.000000000000000E+00 z1= 2 -.643117653490888E-04 0.000000000000000E+00 z1= 3 0.179405803623871E-04 0.000000000000000E+00 alpha(00000298)=0.000000000000000E+00 beta (00000299)=0.125350559996703E+02 gamma(00000299)=0.125350559996703E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 299 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000299)=0.000000000000000E+00 beta (00000300)=0.131098869117299E+02 gamma(00000300)=0.131098869117299E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 300 z1= 1 -.878915515992780E-02 0.000000000000000E+00 z1= 2 0.715446675680536E-04 0.000000000000000E+00 z1= 3 -.218723030594295E-04 0.000000000000000E+00 alpha(00000300)=0.000000000000000E+00 beta (00000301)=0.122918884020887E+02 gamma(00000301)=0.122918884020887E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 301 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000301)=0.000000000000000E+00 beta (00000302)=0.128665056010640E+02 gamma(00000302)=0.128665056010640E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 302 z1= 1 0.902729125938928E-02 0.000000000000000E+00 z1= 2 -.758410965066170E-04 0.000000000000000E+00 z1= 3 0.209564751247939E-04 0.000000000000000E+00 alpha(00000302)=0.000000000000000E+00 beta (00000303)=0.128415039725017E+02 gamma(00000303)=0.128415039725017E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 303 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000303)=0.000000000000000E+00 beta (00000304)=0.134632275075655E+02 gamma(00000304)=0.134632275075655E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 304 z1= 1 -.923964262329452E-02 0.000000000000000E+00 z1= 2 0.814639486050569E-04 0.000000000000000E+00 z1= 3 -.285268779878446E-04 0.000000000000000E+00 alpha(00000304)=0.000000000000000E+00 beta (00000305)=0.129086479673457E+02 gamma(00000305)=0.129086479673457E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 305 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000305)=0.000000000000000E+00 beta (00000306)=0.134087029064913E+02 gamma(00000306)=0.134087029064913E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 306 z1= 1 0.957853559866012E-02 0.000000000000000E+00 z1= 2 -.797207469649679E-04 0.000000000000000E+00 z1= 3 0.275363161115726E-04 0.000000000000000E+00 alpha(00000306)=0.000000000000000E+00 beta (00000307)=0.123360257891218E+02 gamma(00000307)=0.123360257891218E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 307 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000307)=0.000000000000000E+00 beta (00000308)=0.134916195974557E+02 gamma(00000308)=0.134916195974557E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 308 z1= 1 -.930106335954458E-02 0.000000000000000E+00 z1= 2 0.841775628339092E-04 0.000000000000000E+00 z1= 3 -.321423558529714E-04 0.000000000000000E+00 alpha(00000308)=0.000000000000000E+00 beta (00000309)=0.124609750785065E+02 gamma(00000309)=0.124609750785065E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 309 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000309)=0.000000000000000E+00 beta (00000310)=0.130625021931070E+02 gamma(00000310)=0.130625021931070E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 310 z1= 1 0.948107705658669E-02 0.000000000000000E+00 z1= 2 -.846646527216111E-04 0.000000000000000E+00 z1= 3 0.235777947050933E-04 0.000000000000000E+00 alpha(00000310)=0.000000000000000E+00 beta (00000311)=0.128400728635297E+02 gamma(00000311)=0.128400728635297E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 311 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000311)=0.000000000000000E+00 beta (00000312)=0.133514006940074E+02 gamma(00000312)=0.133514006940074E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 312 z1= 1 -.960053376423022E-02 0.000000000000000E+00 z1= 2 0.862842367074100E-04 0.000000000000000E+00 z1= 3 -.253157673323343E-04 0.000000000000000E+00 alpha(00000312)=0.000000000000000E+00 beta (00000313)=0.123311597764549E+02 gamma(00000313)=0.123311597764549E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 313 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000313)=0.000000000000000E+00 beta (00000314)=0.126397417721814E+02 gamma(00000314)=0.126397417721814E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 314 z1= 1 0.950099517350610E-02 0.000000000000000E+00 z1= 2 -.874742012476051E-04 0.000000000000000E+00 z1= 3 0.207867563276713E-04 0.000000000000000E+00 alpha(00000314)=0.000000000000000E+00 beta (00000315)=0.123920539758713E+02 gamma(00000315)=0.123920539758713E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 315 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000315)=0.000000000000000E+00 beta (00000316)=0.129664709780071E+02 gamma(00000316)=0.129664709780071E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 316 z1= 1 -.880812669972833E-02 0.000000000000000E+00 z1= 2 0.904251144726578E-04 0.000000000000000E+00 z1= 3 -.188572373633290E-04 0.000000000000000E+00 alpha(00000316)=0.000000000000000E+00 beta (00000317)=0.128777268538209E+02 gamma(00000317)=0.128777268538209E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 317 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000317)=0.000000000000000E+00 beta (00000318)=0.135164343555728E+02 gamma(00000318)=0.135164343555728E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 318 z1= 1 0.814499320080695E-02 0.000000000000000E+00 z1= 2 -.906904389198510E-04 0.000000000000000E+00 z1= 3 0.137605188206142E-04 0.000000000000000E+00 alpha(00000318)=0.000000000000000E+00 beta (00000319)=0.129166507868461E+02 gamma(00000319)=0.129166507868461E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 319 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000319)=0.000000000000000E+00 beta (00000320)=0.131229954018083E+02 gamma(00000320)=0.131229954018083E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 320 z1= 1 -.808250223639665E-02 0.000000000000000E+00 z1= 2 0.920010186414360E-04 0.000000000000000E+00 z1= 3 -.108793103476146E-04 0.000000000000000E+00 alpha(00000320)=0.000000000000000E+00 beta (00000321)=0.121751981182053E+02 gamma(00000321)=0.121751981182053E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 321 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000321)=0.000000000000000E+00 beta (00000322)=0.131375029914700E+02 gamma(00000322)=0.131375029914700E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 322 z1= 1 0.771349153667016E-02 0.000000000000000E+00 z1= 2 -.880610682365058E-04 0.000000000000000E+00 z1= 3 0.813305318696744E-05 0.000000000000000E+00 alpha(00000322)=0.000000000000000E+00 beta (00000323)=0.129234496639222E+02 gamma(00000323)=0.129234496639222E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 323 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000323)=0.000000000000000E+00 beta (00000324)=0.133950135765389E+02 gamma(00000324)=0.133950135765389E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 324 z1= 1 -.770061322144306E-02 0.000000000000000E+00 z1= 2 0.905139665486536E-04 0.000000000000000E+00 z1= 3 -.551097727218410E-05 0.000000000000000E+00 alpha(00000324)=0.000000000000000E+00 beta (00000325)=0.124213890483337E+02 gamma(00000325)=0.124213890483337E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 325 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000325)=0.000000000000000E+00 beta (00000326)=0.137413623170310E+02 gamma(00000326)=0.137413623170310E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 326 z1= 1 0.744958199160217E-02 0.000000000000000E+00 z1= 2 -.872119790184223E-04 0.000000000000000E+00 z1= 3 0.560251451404159E-05 0.000000000000000E+00 alpha(00000326)=0.000000000000000E+00 beta (00000327)=0.125959298761909E+02 gamma(00000327)=0.125959298761909E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 327 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000327)=0.000000000000000E+00 beta (00000328)=0.134405598454910E+02 gamma(00000328)=0.134405598454910E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 328 z1= 1 -.765413491937180E-02 0.000000000000000E+00 z1= 2 0.906150500427881E-04 0.000000000000000E+00 z1= 3 0.455503294507151E-05 0.000000000000000E+00 alpha(00000328)=0.000000000000000E+00 beta (00000329)=0.123281132030217E+02 gamma(00000329)=0.123281132030217E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 329 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000329)=0.000000000000000E+00 beta (00000330)=0.134389235296418E+02 gamma(00000330)=0.134389235296418E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 330 z1= 1 0.767470658034764E-02 0.000000000000000E+00 z1= 2 -.885080498199851E-04 0.000000000000000E+00 z1= 3 -.857889477082742E-05 0.000000000000000E+00 alpha(00000330)=0.000000000000000E+00 beta (00000331)=0.127513351629270E+02 gamma(00000331)=0.127513351629270E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 331 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000331)=0.000000000000000E+00 beta (00000332)=0.134937895588910E+02 gamma(00000332)=0.134937895588910E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 332 z1= 1 -.789870216027631E-02 0.000000000000000E+00 z1= 2 0.100233539765024E-03 0.000000000000000E+00 z1= 3 0.101188909356623E-04 0.000000000000000E+00 alpha(00000332)=0.000000000000000E+00 beta (00000333)=0.123572126416552E+02 gamma(00000333)=0.123572126416552E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 333 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000333)=0.000000000000000E+00 beta (00000334)=0.131113426175379E+02 gamma(00000334)=0.131113426175379E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 334 z1= 1 0.768184124852631E-02 0.000000000000000E+00 z1= 2 -.104289846601107E-03 0.000000000000000E+00 z1= 3 -.152215468957409E-04 0.000000000000000E+00 alpha(00000334)=0.000000000000000E+00 beta (00000335)=0.126410561647116E+02 gamma(00000335)=0.126410561647116E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 335 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000335)=0.000000000000000E+00 beta (00000336)=0.129312603133951E+02 gamma(00000336)=0.129312603133951E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 336 z1= 1 -.728988312377802E-02 0.000000000000000E+00 z1= 2 0.124209601113335E-03 0.000000000000000E+00 z1= 3 0.169066718638755E-04 0.000000000000000E+00 alpha(00000336)=0.000000000000000E+00 beta (00000337)=0.122526017876247E+02 gamma(00000337)=0.122526017876247E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 337 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000337)=0.000000000000000E+00 beta (00000338)=0.128618917229201E+02 gamma(00000338)=0.128618917229201E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 338 z1= 1 0.653066049699907E-02 0.000000000000000E+00 z1= 2 -.126582995672407E-03 0.000000000000000E+00 z1= 3 -.222020483790203E-04 0.000000000000000E+00 alpha(00000338)=0.000000000000000E+00 beta (00000339)=0.123157410535406E+02 gamma(00000339)=0.123157410535406E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 339 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000339)=0.000000000000000E+00 beta (00000340)=0.133275267885291E+02 gamma(00000340)=0.133275267885291E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 340 z1= 1 -.562195403494244E-02 0.000000000000000E+00 z1= 2 0.138093171014854E-03 0.000000000000000E+00 z1= 3 0.201846146484885E-04 0.000000000000000E+00 alpha(00000340)=0.000000000000000E+00 beta (00000341)=0.123427808659315E+02 gamma(00000341)=0.123427808659315E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 341 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000341)=0.000000000000000E+00 beta (00000342)=0.133107001916708E+02 gamma(00000342)=0.133107001916708E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 342 z1= 1 0.483346759251218E-02 0.000000000000000E+00 z1= 2 -.132454738997192E-03 0.000000000000000E+00 z1= 3 -.285924121370489E-04 0.000000000000000E+00 alpha(00000342)=0.000000000000000E+00 beta (00000343)=0.127866333738131E+02 gamma(00000343)=0.127866333738131E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 343 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000343)=0.000000000000000E+00 beta (00000344)=0.130785830434412E+02 gamma(00000344)=0.130785830434412E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 344 z1= 1 -.434915837121186E-02 0.000000000000000E+00 z1= 2 0.158076726191322E-03 0.000000000000000E+00 z1= 3 0.244849427103339E-04 0.000000000000000E+00 alpha(00000344)=0.000000000000000E+00 beta (00000345)=0.119129904532820E+02 gamma(00000345)=0.119129904532820E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 345 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000345)=0.000000000000000E+00 beta (00000346)=0.125986277797401E+02 gamma(00000346)=0.125986277797401E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 346 z1= 1 0.388348392221799E-02 0.000000000000000E+00 z1= 2 -.142740973280552E-03 0.000000000000000E+00 z1= 3 -.299572100245985E-04 0.000000000000000E+00 alpha(00000346)=0.000000000000000E+00 beta (00000347)=0.124981326693883E+02 gamma(00000347)=0.124981326693883E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 347 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000347)=0.000000000000000E+00 beta (00000348)=0.132374753565801E+02 gamma(00000348)=0.132374753565801E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 348 z1= 1 -.376224363011571E-02 0.000000000000000E+00 z1= 2 0.169305588265809E-03 0.000000000000000E+00 z1= 3 0.145442466522591E-04 0.000000000000000E+00 alpha(00000348)=0.000000000000000E+00 beta (00000349)=0.121952406547309E+02 gamma(00000349)=0.121952406547309E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 349 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000349)=0.000000000000000E+00 beta (00000350)=0.122074371888929E+02 gamma(00000350)=0.122074371888929E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 350 z1= 1 0.386812511755124E-02 0.000000000000000E+00 z1= 2 -.138847151737140E-03 0.000000000000000E+00 z1= 3 -.349167444279171E-04 0.000000000000000E+00 alpha(00000350)=0.000000000000000E+00 beta (00000351)=0.105632341607560E+02 gamma(00000351)=0.105632341607560E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 351 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000351)=0.000000000000000E+00 beta (00000352)=0.798884396811447E+01 gamma(00000352)=0.798884396811447E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 352 z1= 1 -.559804848502166E-02 0.000000000000000E+00 z1= 2 0.302376040077348E-03 0.000000000000000E+00 z1= 3 -.172346099032037E-04 0.000000000000000E+00 alpha(00000352)=0.000000000000000E+00 beta (00000353)=0.242415309387484E+02 gamma(00000353)=-.242415309387484E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 353 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000353)=0.000000000000000E+00 beta (00000354)=0.406646389895609E+02 gamma(00000354)=0.406646389895609E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 354 z1= 1 -.328895635452559E-02 0.000000000000000E+00 z1= 2 0.228569613251371E-03 0.000000000000000E+00 z1= 3 -.357559134355969E-04 0.000000000000000E+00 alpha(00000354)=0.000000000000000E+00 beta (00000355)=0.110246347526704E+02 gamma(00000355)=-.110246347526704E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 355 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000355)=0.000000000000000E+00 beta (00000356)=0.100375856232798E+02 gamma(00000356)=0.100375856232798E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 356 z1= 1 -.422002345421249E-02 0.000000000000000E+00 z1= 2 0.119074950871698E-03 0.000000000000000E+00 z1= 3 0.319720024276893E-04 0.000000000000000E+00 alpha(00000356)=0.000000000000000E+00 beta (00000357)=0.110458066157812E+02 gamma(00000357)=0.110458066157812E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 357 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000357)=0.000000000000000E+00 beta (00000358)=0.122548262567911E+02 gamma(00000358)=0.122548262567911E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 358 z1= 1 0.411336488621720E-02 0.000000000000000E+00 z1= 2 -.152420370614517E-03 0.000000000000000E+00 z1= 3 -.327810885088805E-05 0.000000000000000E+00 alpha(00000358)=0.000000000000000E+00 beta (00000359)=0.120941693869707E+02 gamma(00000359)=0.120941693869707E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 359 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000359)=0.000000000000000E+00 beta (00000360)=0.134550303389439E+02 gamma(00000360)=0.134550303389439E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 360 z1= 1 -.396351328334959E-02 0.000000000000000E+00 z1= 2 0.107144036144920E-03 0.000000000000000E+00 z1= 3 0.152777603058527E-04 0.000000000000000E+00 alpha(00000360)=0.000000000000000E+00 beta (00000361)=0.121225971516992E+02 gamma(00000361)=0.121225971516992E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 361 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000361)=0.000000000000000E+00 beta (00000362)=0.126255132145058E+02 gamma(00000362)=0.126255132145058E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 362 z1= 1 0.385386269112992E-02 0.000000000000000E+00 z1= 2 -.128334978285870E-03 0.000000000000000E+00 z1= 3 -.266087926380644E-05 0.000000000000000E+00 alpha(00000362)=0.000000000000000E+00 beta (00000363)=0.120026332835482E+02 gamma(00000363)=0.120026332835482E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 363 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000363)=0.000000000000000E+00 beta (00000364)=0.134226287444365E+02 gamma(00000364)=0.134226287444365E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 364 z1= 1 -.313572497933097E-02 0.000000000000000E+00 z1= 2 0.982033395747380E-04 0.000000000000000E+00 z1= 3 0.103065781478523E-04 0.000000000000000E+00 alpha(00000364)=0.000000000000000E+00 beta (00000365)=0.124972649096224E+02 gamma(00000365)=0.124972649096224E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 365 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000365)=0.000000000000000E+00 beta (00000366)=0.132644933805168E+02 gamma(00000366)=0.132644933805168E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 366 z1= 1 0.267010552785745E-02 0.000000000000000E+00 z1= 2 -.121789133079714E-03 0.000000000000000E+00 z1= 3 0.518716419083880E-05 0.000000000000000E+00 alpha(00000366)=0.000000000000000E+00 beta (00000367)=0.126873188912197E+02 gamma(00000367)=0.126873188912197E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 367 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000367)=0.000000000000000E+00 beta (00000368)=0.128366156598809E+02 gamma(00000368)=0.128366156598809E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 368 z1= 1 -.266516159143285E-02 0.000000000000000E+00 z1= 2 0.103905326208750E-03 0.000000000000000E+00 z1= 3 0.753158745120462E-05 0.000000000000000E+00 alpha(00000368)=0.000000000000000E+00 beta (00000369)=0.123493263606171E+02 gamma(00000369)=0.123493263606171E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 369 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000369)=0.000000000000000E+00 beta (00000370)=0.135572010217242E+02 gamma(00000370)=0.135572010217242E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 370 z1= 1 0.259352362572066E-02 0.000000000000000E+00 z1= 2 -.125735691574174E-03 0.000000000000000E+00 z1= 3 0.103488461319473E-04 0.000000000000000E+00 alpha(00000370)=0.000000000000000E+00 beta (00000371)=0.128324169732221E+02 gamma(00000371)=0.128324169732221E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 371 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000371)=0.000000000000000E+00 beta (00000372)=0.130828946529994E+02 gamma(00000372)=0.130828946529994E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 372 z1= 1 -.275361041853421E-02 0.000000000000000E+00 z1= 2 0.110199528755781E-03 0.000000000000000E+00 z1= 3 0.447820008423876E-05 0.000000000000000E+00 alpha(00000372)=0.000000000000000E+00 beta (00000373)=0.120111706191007E+02 gamma(00000373)=0.120111706191007E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 373 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000373)=0.000000000000000E+00 beta (00000374)=0.131367911132412E+02 gamma(00000374)=0.131367911132412E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 374 z1= 1 0.268403575278163E-02 0.000000000000000E+00 z1= 2 -.135007622175534E-03 0.000000000000000E+00 z1= 3 0.136675895921359E-04 0.000000000000000E+00 alpha(00000374)=0.000000000000000E+00 beta (00000375)=0.132508084755005E+02 gamma(00000375)=0.132508084755005E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 375 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000375)=0.000000000000000E+00 beta (00000376)=0.128669181329161E+02 gamma(00000376)=0.128669181329161E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 376 z1= 1 -.282909290500195E-02 0.000000000000000E+00 z1= 2 0.120045938794112E-03 0.000000000000000E+00 z1= 3 0.193541180934921E-05 0.000000000000000E+00 alpha(00000376)=0.000000000000000E+00 beta (00000377)=0.123340085424578E+02 gamma(00000377)=0.123340085424578E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 377 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000377)=0.000000000000000E+00 beta (00000378)=0.134134298411648E+02 gamma(00000378)=0.134134298411648E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 378 z1= 1 0.269115812402816E-02 0.000000000000000E+00 z1= 2 -.144587403992921E-03 0.000000000000000E+00 z1= 3 0.188974368107923E-04 0.000000000000000E+00 alpha(00000378)=0.000000000000000E+00 beta (00000379)=0.125779924823541E+02 gamma(00000379)=0.125779924823541E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 379 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000379)=0.000000000000000E+00 beta (00000380)=0.131230352610563E+02 gamma(00000380)=0.131230352610563E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 380 z1= 1 -.277072985110835E-02 0.000000000000000E+00 z1= 2 0.122549494979078E-03 0.000000000000000E+00 z1= 3 -.111310099566513E-05 0.000000000000000E+00 alpha(00000380)=0.000000000000000E+00 beta (00000381)=0.124950949488036E+02 gamma(00000381)=0.124950949488036E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 381 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000381)=0.000000000000000E+00 beta (00000382)=0.133522899697972E+02 gamma(00000382)=0.133522899697972E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 382 z1= 1 0.283859915302431E-02 0.000000000000000E+00 z1= 2 -.144642665252707E-03 0.000000000000000E+00 z1= 3 0.209307865670659E-04 0.000000000000000E+00 alpha(00000382)=0.000000000000000E+00 beta (00000383)=0.126648862188810E+02 gamma(00000383)=0.126648862188810E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 383 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000383)=0.000000000000000E+00 beta (00000384)=0.129151067768049E+02 gamma(00000384)=0.129151067768049E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 384 z1= 1 -.321472258752018E-02 0.000000000000000E+00 z1= 2 0.115118730419574E-03 0.000000000000000E+00 z1= 3 0.287883953147943E-05 0.000000000000000E+00 alpha(00000384)=0.000000000000000E+00 beta (00000385)=0.124522947760768E+02 gamma(00000385)=0.124522947760768E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 385 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000385)=0.000000000000000E+00 beta (00000386)=0.125956213380122E+02 gamma(00000386)=0.125956213380122E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 386 z1= 1 0.368728031067934E-02 0.000000000000000E+00 z1= 2 -.150278862753142E-03 0.000000000000000E+00 z1= 3 0.188886903663657E-04 0.000000000000000E+00 alpha(00000386)=0.000000000000000E+00 beta (00000387)=0.126725256933584E+02 gamma(00000387)=0.126725256933584E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 387 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000387)=0.000000000000000E+00 beta (00000388)=0.131959421879394E+02 gamma(00000388)=0.131959421879394E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 388 z1= 1 -.409907797215220E-02 0.000000000000000E+00 z1= 2 0.101355315629758E-03 0.000000000000000E+00 z1= 3 0.125235256046187E-04 0.000000000000000E+00 alpha(00000388)=0.000000000000000E+00 beta (00000389)=0.128131220923169E+02 gamma(00000389)=0.128131220923169E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 389 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000389)=0.000000000000000E+00 beta (00000390)=0.135311135193956E+02 gamma(00000390)=0.135311135193956E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 390 z1= 1 0.459090623671212E-02 0.000000000000000E+00 z1= 2 -.148990209305790E-03 0.000000000000000E+00 z1= 3 0.162632431386988E-04 0.000000000000000E+00 alpha(00000390)=0.000000000000000E+00 beta (00000391)=0.127723562637561E+02 gamma(00000391)=0.127723562637561E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 391 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000391)=0.000000000000000E+00 beta (00000392)=0.134217320383129E+02 gamma(00000392)=0.134217320383129E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 392 z1= 1 -.505744617786513E-02 0.000000000000000E+00 z1= 2 0.874354575144988E-04 0.000000000000000E+00 z1= 3 0.269093835361044E-04 0.000000000000000E+00 alpha(00000392)=0.000000000000000E+00 beta (00000393)=0.127289608342198E+02 gamma(00000393)=0.127289608342198E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 393 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000393)=0.000000000000000E+00 beta (00000394)=0.127716837788477E+02 gamma(00000394)=0.127716837788477E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 394 z1= 1 0.566687563261855E-02 0.000000000000000E+00 z1= 2 -.143550106119791E-03 0.000000000000000E+00 z1= 3 0.684724274638076E-05 0.000000000000000E+00 alpha(00000394)=0.000000000000000E+00 beta (00000395)=0.127728494296063E+02 gamma(00000395)=0.127728494296063E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 395 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000395)=0.000000000000000E+00 beta (00000396)=0.133818040870745E+02 gamma(00000396)=0.133818040870745E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 396 z1= 1 -.604537578702335E-02 0.000000000000000E+00 z1= 2 0.860348628587528E-04 0.000000000000000E+00 z1= 3 0.351974494165819E-04 0.000000000000000E+00 alpha(00000396)=0.000000000000000E+00 beta (00000397)=0.123997366640432E+02 gamma(00000397)=0.123997366640432E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 397 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000397)=0.000000000000000E+00 beta (00000398)=0.129216457896787E+02 gamma(00000398)=0.129216457896787E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 398 z1= 1 0.649227400005729E-02 0.000000000000000E+00 z1= 2 -.147920302938535E-03 0.000000000000000E+00 z1= 3 -.311915359794078E-05 0.000000000000000E+00 alpha(00000398)=0.000000000000000E+00 beta (00000399)=0.124201875020879E+02 gamma(00000399)=0.124201875020879E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 399 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000399)=0.000000000000000E+00 beta (00000400)=0.139540313726572E+02 gamma(00000400)=0.139540313726572E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 400 z1= 1 -.659450648742741E-02 0.000000000000000E+00 z1= 2 0.587488283741362E-04 0.000000000000000E+00 z1= 3 0.471084908039438E-04 0.000000000000000E+00 alpha(00000400)=0.000000000000000E+00 beta (00000401)=0.126205239571293E+02 gamma(00000401)=0.126205239571293E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 401 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000401)=0.000000000000000E+00 beta (00000402)=0.132768611118802E+02 gamma(00000402)=0.132768611118802E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 402 z1= 1 0.721032178136760E-02 0.000000000000000E+00 z1= 2 -.131933168804939E-03 0.000000000000000E+00 z1= 3 0.279080831922825E-05 0.000000000000000E+00 alpha(00000402)=0.000000000000000E+00 beta (00000403)=0.124749762180636E+02 gamma(00000403)=0.124749762180636E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 403 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000403)=0.000000000000000E+00 beta (00000404)=0.130865155409403E+02 gamma(00000404)=0.130865155409403E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 404 z1= 1 -.786855872961378E-02 0.000000000000000E+00 z1= 2 0.482516185561052E-04 0.000000000000000E+00 z1= 3 0.481151015718273E-04 0.000000000000000E+00 alpha(00000404)=0.000000000000000E+00 beta (00000405)=0.130446362702748E+02 gamma(00000405)=0.130446362702748E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 405 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000405)=0.000000000000000E+00 beta (00000406)=0.131877001987786E+02 gamma(00000406)=0.131877001987786E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 406 z1= 1 0.846270377130433E-02 0.000000000000000E+00 z1= 2 -.129980245893943E-03 0.000000000000000E+00 z1= 3 0.183045064110692E-05 0.000000000000000E+00 alpha(00000406)=0.000000000000000E+00 beta (00000407)=0.126603604780642E+02 gamma(00000407)=0.126603604780642E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 407 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000407)=0.000000000000000E+00 beta (00000408)=0.125998420892483E+02 gamma(00000408)=0.125998420892483E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 408 z1= 1 -.885379143162596E-02 0.000000000000000E+00 z1= 2 0.474042002290122E-04 0.000000000000000E+00 z1= 3 0.456970397791125E-04 0.000000000000000E+00 alpha(00000408)=0.000000000000000E+00 beta (00000409)=0.125370508077538E+02 gamma(00000409)=0.125370508077538E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 409 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000409)=0.000000000000000E+00 beta (00000410)=0.135650826186492E+02 gamma(00000410)=0.135650826186492E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 410 z1= 1 0.813296589375138E-02 0.000000000000000E+00 z1= 2 -.131807750662732E-03 0.000000000000000E+00 z1= 3 0.831095237997076E-05 0.000000000000000E+00 alpha(00000410)=0.000000000000000E+00 beta (00000411)=0.124951579156101E+02 gamma(00000411)=0.124951579156101E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 411 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000411)=0.000000000000000E+00 beta (00000412)=0.134169671943888E+02 gamma(00000412)=0.134169671943888E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 412 z1= 1 -.726402961634803E-02 0.000000000000000E+00 z1= 2 0.221797277659900E-04 0.000000000000000E+00 z1= 3 0.460644682217976E-04 0.000000000000000E+00 alpha(00000412)=0.000000000000000E+00 beta (00000413)=0.128376513451945E+02 gamma(00000413)=0.128376513451945E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 413 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000413)=0.000000000000000E+00 beta (00000414)=0.132558803163205E+02 gamma(00000414)=0.132558803163205E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 414 z1= 1 0.660104543608418E-02 0.000000000000000E+00 z1= 2 -.123950165355338E-03 0.000000000000000E+00 z1= 3 0.117025334646931E-04 0.000000000000000E+00 alpha(00000414)=0.000000000000000E+00 beta (00000415)=0.126871709430637E+02 gamma(00000415)=0.126871709430637E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 415 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000415)=0.000000000000000E+00 beta (00000416)=0.137444549776405E+02 gamma(00000416)=0.137444549776405E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 416 z1= 1 -.593975347065910E-02 0.000000000000000E+00 z1= 2 0.138908345318467E-04 0.000000000000000E+00 z1= 3 0.403285426842874E-04 0.000000000000000E+00 alpha(00000416)=0.000000000000000E+00 beta (00000417)=0.126384088664170E+02 gamma(00000417)=0.126384088664170E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 417 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000417)=0.000000000000000E+00 beta (00000418)=0.124575793494446E+02 gamma(00000418)=0.124575793494446E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 418 z1= 1 0.622749533808025E-02 0.000000000000000E+00 z1= 2 -.859920709441720E-04 0.000000000000000E+00 z1= 3 -.251996084573813E-07 0.000000000000000E+00 alpha(00000418)=0.000000000000000E+00 beta (00000419)=0.128609308963563E+02 gamma(00000419)=0.128609308963563E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 419 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000419)=0.000000000000000E+00 beta (00000420)=0.135343665086390E+02 gamma(00000420)=0.135343665086390E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 420 z1= 1 -.630597080658247E-02 0.000000000000000E+00 z1= 2 0.500989254182153E-05 0.000000000000000E+00 z1= 3 0.316671156670042E-04 0.000000000000000E+00 alpha(00000420)=0.000000000000000E+00 beta (00000421)=0.126942395796031E+02 gamma(00000421)=0.126942395796031E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 421 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000421)=0.000000000000000E+00 beta (00000422)=0.132394102530679E+02 gamma(00000422)=0.132394102530679E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 422 z1= 1 0.679258900324471E-02 0.000000000000000E+00 z1= 2 -.478738933691429E-04 0.000000000000000E+00 z1= 3 -.399206904572614E-05 0.000000000000000E+00 alpha(00000422)=0.000000000000000E+00 beta (00000423)=0.124826263848903E+02 gamma(00000423)=0.124826263848903E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 423 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000423)=0.000000000000000E+00 beta (00000424)=0.131644282393071E+02 gamma(00000424)=0.131644282393071E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 424 z1= 1 -.750002090385702E-02 0.000000000000000E+00 z1= 2 -.467019826255266E-05 0.000000000000000E+00 z1= 3 0.193076679912878E-04 0.000000000000000E+00 alpha(00000424)=0.000000000000000E+00 beta (00000425)=0.123766267417596E+02 gamma(00000425)=0.123766267417596E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 425 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000425)=0.000000000000000E+00 beta (00000426)=0.131114249576129E+02 gamma(00000426)=0.131114249576129E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 426 z1= 1 0.791452624379755E-02 0.000000000000000E+00 z1= 2 0.966668105138388E-05 0.000000000000000E+00 z1= 3 -.763776965553110E-05 0.000000000000000E+00 alpha(00000426)=0.000000000000000E+00 beta (00000427)=0.120866685544696E+02 gamma(00000427)=0.120866685544696E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 427 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000427)=0.000000000000000E+00 beta (00000428)=0.130237723214271E+02 gamma(00000428)=0.130237723214271E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 428 z1= 1 -.775947922568473E-02 0.000000000000000E+00 z1= 2 -.306599489699128E-04 0.000000000000000E+00 z1= 3 0.297507928972851E-05 0.000000000000000E+00 alpha(00000428)=0.000000000000000E+00 beta (00000429)=0.128537410424623E+02 gamma(00000429)=0.128537410424623E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 429 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000429)=0.000000000000000E+00 beta (00000430)=0.130583799545001E+02 gamma(00000430)=0.130583799545001E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 430 z1= 1 0.765914946262948E-02 0.000000000000000E+00 z1= 2 0.676557426476723E-04 0.000000000000000E+00 z1= 3 -.122032880852020E-04 0.000000000000000E+00 alpha(00000430)=0.000000000000000E+00 beta (00000431)=0.123502681320573E+02 gamma(00000431)=0.123502681320573E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 431 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000431)=0.000000000000000E+00 beta (00000432)=0.129284406401901E+02 gamma(00000432)=0.129284406401901E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 432 z1= 1 -.689347971962295E-02 0.000000000000000E+00 z1= 2 -.534156413586071E-04 0.000000000000000E+00 z1= 3 -.608017870477477E-05 0.000000000000000E+00 alpha(00000432)=0.000000000000000E+00 beta (00000433)=0.121274756569310E+02 gamma(00000433)=0.121274756569310E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 433 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000433)=0.000000000000000E+00 beta (00000434)=0.134457479397609E+02 gamma(00000434)=0.134457479397609E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 434 z1= 1 0.584338078960790E-02 0.000000000000000E+00 z1= 2 0.125087404727986E-03 0.000000000000000E+00 z1= 3 -.244795568038445E-04 0.000000000000000E+00 alpha(00000434)=0.000000000000000E+00 beta (00000435)=0.133011154897193E+02 gamma(00000435)=0.133011154897193E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 435 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000435)=0.000000000000000E+00 beta (00000436)=0.131651685836427E+02 gamma(00000436)=0.131651685836427E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 436 z1= 1 -.582856472776596E-02 0.000000000000000E+00 z1= 2 -.755073938164593E-04 0.000000000000000E+00 z1= 3 -.165270453488930E-04 0.000000000000000E+00 alpha(00000436)=0.000000000000000E+00 beta (00000437)=0.125548955275571E+02 gamma(00000437)=0.125548955275571E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 437 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000437)=0.000000000000000E+00 beta (00000438)=0.131867709307953E+02 gamma(00000438)=0.131867709307953E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 438 z1= 1 0.565466660628521E-02 0.000000000000000E+00 z1= 2 0.181851195157433E-03 0.000000000000000E+00 z1= 3 -.295432331646308E-04 0.000000000000000E+00 alpha(00000438)=0.000000000000000E+00 beta (00000439)=0.124633039085248E+02 gamma(00000439)=0.124633039085248E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 439 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000439)=0.000000000000000E+00 beta (00000440)=0.125442231051711E+02 gamma(00000440)=0.125442231051711E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 440 z1= 1 -.564355893707258E-02 0.000000000000000E+00 z1= 2 -.915764697537302E-04 0.000000000000000E+00 z1= 3 -.239023001907290E-04 0.000000000000000E+00 alpha(00000440)=0.000000000000000E+00 beta (00000441)=0.127736243341984E+02 gamma(00000441)=0.127736243341984E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 441 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000441)=0.000000000000000E+00 beta (00000442)=0.131151463550748E+02 gamma(00000442)=0.131151463550748E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 442 z1= 1 0.535193337512668E-02 0.000000000000000E+00 z1= 2 0.242076818348856E-03 0.000000000000000E+00 z1= 3 -.502840019324010E-04 0.000000000000000E+00 alpha(00000442)=0.000000000000000E+00 beta (00000443)=0.129177025542540E+02 gamma(00000443)=0.129177025542540E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 443 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000443)=0.000000000000000E+00 beta (00000444)=0.135328375059680E+02 gamma(00000444)=0.135328375059680E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 444 z1= 1 -.526388260178860E-02 0.000000000000000E+00 z1= 2 -.862054447874783E-04 0.000000000000000E+00 z1= 3 -.402197867235124E-04 0.000000000000000E+00 alpha(00000444)=0.000000000000000E+00 beta (00000445)=0.128075337092108E+02 gamma(00000445)=0.128075337092108E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 445 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000445)=0.000000000000000E+00 beta (00000446)=0.136411368600473E+02 gamma(00000446)=0.136411368600473E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 446 z1= 1 0.541701341489535E-02 0.000000000000000E+00 z1= 2 0.273883167506770E-03 0.000000000000000E+00 z1= 3 -.576234523517514E-04 0.000000000000000E+00 alpha(00000446)=0.000000000000000E+00 beta (00000447)=0.126074724714474E+02 gamma(00000447)=0.126074724714474E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 447 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000447)=0.000000000000000E+00 beta (00000448)=0.131827890916841E+02 gamma(00000448)=0.131827890916841E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 448 z1= 1 -.575119346941223E-02 0.000000000000000E+00 z1= 2 -.139539081133776E-03 0.000000000000000E+00 z1= 3 -.272425191171099E-04 0.000000000000000E+00 alpha(00000448)=0.000000000000000E+00 beta (00000449)=0.125958480191890E+02 gamma(00000449)=0.125958480191890E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 449 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000449)=0.000000000000000E+00 beta (00000450)=0.133816274340702E+02 gamma(00000450)=0.133816274340702E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 450 z1= 1 0.568065821522588E-02 0.000000000000000E+00 z1= 2 0.291115090550010E-03 0.000000000000000E+00 z1= 3 -.501985405420682E-04 0.000000000000000E+00 alpha(00000450)=0.000000000000000E+00 beta (00000451)=0.126438622868943E+02 gamma(00000451)=0.126438622868943E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 451 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000451)=0.000000000000000E+00 beta (00000452)=0.137877015664050E+02 gamma(00000452)=0.137877015664050E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 452 z1= 1 -.513528425161978E-02 0.000000000000000E+00 z1= 2 -.198868916846393E-03 0.000000000000000E+00 z1= 3 -.893069389464713E-05 0.000000000000000E+00 alpha(00000452)=0.000000000000000E+00 beta (00000453)=0.119538997901039E+02 gamma(00000453)=0.119538997901039E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 453 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000453)=0.000000000000000E+00 beta (00000454)=0.131925784503086E+02 gamma(00000454)=0.131925784503086E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 454 z1= 1 0.437302525434347E-02 0.000000000000000E+00 z1= 2 0.283874436104038E-03 0.000000000000000E+00 z1= 3 -.327817484372899E-04 0.000000000000000E+00 alpha(00000454)=0.000000000000000E+00 beta (00000455)=0.122689157384049E+02 gamma(00000455)=0.122689157384049E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 455 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000455)=0.000000000000000E+00 beta (00000456)=0.130841396923951E+02 gamma(00000456)=0.130841396923951E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 456 z1= 1 -.350405743655269E-02 0.000000000000000E+00 z1= 2 -.269048105265620E-03 0.000000000000000E+00 z1= 3 0.847365389941178E-06 0.000000000000000E+00 alpha(00000456)=0.000000000000000E+00 beta (00000457)=0.123645357434335E+02 gamma(00000457)=0.123645357434335E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 457 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000457)=0.000000000000000E+00 beta (00000458)=0.132224129541017E+02 gamma(00000458)=0.132224129541017E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 458 z1= 1 0.294603978656610E-02 0.000000000000000E+00 z1= 2 0.312851867700921E-03 0.000000000000000E+00 z1= 3 -.262917650492593E-04 0.000000000000000E+00 alpha(00000458)=0.000000000000000E+00 beta (00000459)=0.127825166320715E+02 gamma(00000459)=0.127825166320715E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 459 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000459)=0.000000000000000E+00 beta (00000460)=0.131328356381678E+02 gamma(00000460)=0.131328356381678E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 460 z1= 1 -.284829858492298E-02 0.000000000000000E+00 z1= 2 -.342423005633455E-03 0.000000000000000E+00 z1= 3 0.126838219100480E-04 0.000000000000000E+00 alpha(00000460)=0.000000000000000E+00 beta (00000461)=0.129276623906559E+02 gamma(00000461)=0.129276623906559E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 461 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000461)=0.000000000000000E+00 beta (00000462)=0.127788809802300E+02 gamma(00000462)=0.127788809802300E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 462 z1= 1 0.325168205897869E-02 0.000000000000000E+00 z1= 2 0.377468993071738E-03 0.000000000000000E+00 z1= 3 -.241719116851333E-04 0.000000000000000E+00 alpha(00000462)=0.000000000000000E+00 beta (00000463)=0.126815124494448E+02 gamma(00000463)=0.126815124494448E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 463 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000463)=0.000000000000000E+00 beta (00000464)=0.136630139544743E+02 gamma(00000464)=0.136630139544743E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 464 z1= 1 -.351845641631195E-02 0.000000000000000E+00 z1= 2 -.403938311282875E-03 0.000000000000000E+00 z1= 3 0.210183336940942E-04 0.000000000000000E+00 alpha(00000464)=0.000000000000000E+00 beta (00000465)=0.124189747746820E+02 gamma(00000465)=0.124189747746820E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 465 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000465)=0.000000000000000E+00 beta (00000466)=0.130259494954861E+02 gamma(00000466)=0.130259494954861E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 466 z1= 1 0.377099852558275E-02 0.000000000000000E+00 z1= 2 0.399161516610168E-03 0.000000000000000E+00 z1= 3 -.227993857097521E-04 0.000000000000000E+00 alpha(00000466)=0.000000000000000E+00 beta (00000467)=0.127877843680452E+02 gamma(00000467)=0.127877843680452E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 467 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000467)=0.000000000000000E+00 beta (00000468)=0.132557130153854E+02 gamma(00000468)=0.132557130153854E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 468 z1= 1 -.357398458731966E-02 0.000000000000000E+00 z1= 2 -.460093382729485E-03 0.000000000000000E+00 z1= 3 0.240963455997469E-04 0.000000000000000E+00 alpha(00000468)=0.000000000000000E+00 beta (00000469)=0.130051360914732E+02 gamma(00000469)=0.130051360914732E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 469 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000469)=0.000000000000000E+00 beta (00000470)=0.130207377437389E+02 gamma(00000470)=0.130207377437389E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 470 z1= 1 0.316468619858924E-02 0.000000000000000E+00 z1= 2 0.453729631148233E-03 0.000000000000000E+00 z1= 3 -.192831368287186E-04 0.000000000000000E+00 alpha(00000470)=0.000000000000000E+00 beta (00000471)=0.126837424286181E+02 gamma(00000471)=0.126837424286181E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 471 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000471)=0.000000000000000E+00 beta (00000472)=0.131531840980185E+02 gamma(00000472)=0.131531840980185E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 472 z1= 1 -.294301001752262E-02 0.000000000000000E+00 z1= 2 -.519455630448824E-03 0.000000000000000E+00 z1= 3 0.284850178756713E-04 0.000000000000000E+00 alpha(00000472)=0.000000000000000E+00 beta (00000473)=0.127626844447597E+02 gamma(00000473)=0.127626844447597E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 473 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000473)=0.000000000000000E+00 beta (00000474)=0.136504269698097E+02 gamma(00000474)=0.136504269698097E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 474 z1= 1 0.305104000667375E-02 0.000000000000000E+00 z1= 2 0.477201432235530E-03 0.000000000000000E+00 z1= 3 -.156932825053636E-04 0.000000000000000E+00 alpha(00000474)=0.000000000000000E+00 beta (00000475)=0.129065969701844E+02 gamma(00000475)=0.129065969701844E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 475 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000475)=0.000000000000000E+00 beta (00000476)=0.131811638078431E+02 gamma(00000476)=0.131811638078431E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 476 z1= 1 -.337961486465510E-02 0.000000000000000E+00 z1= 2 -.546636044353626E-03 0.000000000000000E+00 z1= 3 0.224150099208311E-04 0.000000000000000E+00 alpha(00000476)=0.000000000000000E+00 beta (00000477)=0.127024899516357E+02 gamma(00000477)=0.127024899516357E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 477 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000477)=0.000000000000000E+00 beta (00000478)=0.130296489557436E+02 gamma(00000478)=0.130296489557436E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 478 z1= 1 0.353012131194500E-02 0.000000000000000E+00 z1= 2 0.538544782874744E-03 0.000000000000000E+00 z1= 3 -.142837841474251E-04 0.000000000000000E+00 alpha(00000478)=0.000000000000000E+00 beta (00000479)=0.127574978059512E+02 gamma(00000479)=0.127574978059512E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 479 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000479)=0.000000000000000E+00 beta (00000480)=0.129305097415281E+02 gamma(00000480)=0.129305097415281E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 480 z1= 1 -.360831316460267E-02 0.000000000000000E+00 z1= 2 -.606886646080094E-03 0.000000000000000E+00 z1= 3 0.171041742125909E-04 0.000000000000000E+00 alpha(00000480)=0.000000000000000E+00 beta (00000481)=0.127254563531542E+02 gamma(00000481)=0.127254563531542E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 481 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000481)=0.000000000000000E+00 beta (00000482)=0.126112308592833E+02 gamma(00000482)=0.126112308592833E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 482 z1= 1 0.393829967844771E-02 0.000000000000000E+00 z1= 2 0.623458695906686E-03 0.000000000000000E+00 z1= 3 -.362686178187412E-05 0.000000000000000E+00 alpha(00000482)=0.000000000000000E+00 beta (00000483)=0.130847930063826E+02 gamma(00000483)=0.130847930063826E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 483 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000483)=0.000000000000000E+00 beta (00000484)=0.132883047938388E+02 gamma(00000484)=0.132883047938388E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 484 z1= 1 -.422493888416983E-02 0.000000000000000E+00 z1= 2 -.687356413053159E-03 0.000000000000000E+00 z1= 3 0.145507118821591E-04 0.000000000000000E+00 alpha(00000484)=0.000000000000000E+00 beta (00000485)=0.118843841746506E+02 gamma(00000485)=0.118843841746506E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 485 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000485)=0.000000000000000E+00 beta (00000486)=0.136918529728387E+02 gamma(00000486)=0.136918529728387E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 486 z1= 1 0.396844978593514E-02 0.000000000000000E+00 z1= 2 0.606285906610392E-03 0.000000000000000E+00 z1= 3 0.113398599796531E-04 0.000000000000000E+00 alpha(00000486)=0.000000000000000E+00 beta (00000487)=0.122998493861285E+02 gamma(00000487)=0.122998493861285E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 487 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000487)=0.000000000000000E+00 beta (00000488)=0.135937078777164E+02 gamma(00000488)=0.135937078777164E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 488 z1= 1 -.335415699327432E-02 0.000000000000000E+00 z1= 2 -.636683559761071E-03 0.000000000000000E+00 z1= 3 0.171642081756034E-04 0.000000000000000E+00 alpha(00000488)=0.000000000000000E+00 beta (00000489)=0.123917794819645E+02 gamma(00000489)=0.123917794819645E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 489 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000489)=0.000000000000000E+00 beta (00000490)=0.134646079475299E+02 gamma(00000490)=0.134646079475299E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 490 z1= 1 0.229324965714927E-02 0.000000000000000E+00 z1= 2 0.588252145015117E-03 0.000000000000000E+00 z1= 3 0.218694340760174E-04 0.000000000000000E+00 alpha(00000490)=0.000000000000000E+00 beta (00000491)=0.124852115150903E+02 gamma(00000491)=0.124852115150903E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 491 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000491)=0.000000000000000E+00 beta (00000492)=0.136336077005870E+02 gamma(00000492)=0.136336077005870E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 492 z1= 1 -.156103072885297E-02 0.000000000000000E+00 z1= 2 -.654974540225000E-03 0.000000000000000E+00 z1= 3 0.266606115281656E-04 0.000000000000000E+00 alpha(00000492)=0.000000000000000E+00 beta (00000493)=0.127218771823945E+02 gamma(00000493)=0.127218771823945E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 493 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000493)=0.000000000000000E+00 beta (00000494)=0.130826854359018E+02 gamma(00000494)=0.130826854359018E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 494 z1= 1 0.102356969035871E-02 0.000000000000000E+00 z1= 2 0.617999894844787E-03 0.000000000000000E+00 z1= 3 0.267728935977833E-04 0.000000000000000E+00 alpha(00000494)=0.000000000000000E+00 beta (00000495)=0.123702170200551E+02 gamma(00000495)=0.123702170200551E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 495 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000495)=0.000000000000000E+00 beta (00000496)=0.133303995384889E+02 gamma(00000496)=0.133303995384889E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 496 z1= 1 -.382552986013736E-03 0.000000000000000E+00 z1= 2 -.713452539418977E-03 0.000000000000000E+00 z1= 3 0.405261001020865E-04 0.000000000000000E+00 alpha(00000496)=0.000000000000000E+00 beta (00000497)=0.124378323534687E+02 gamma(00000497)=0.124378323534687E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 497 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000497)=0.000000000000000E+00 beta (00000498)=0.137526364382784E+02 gamma(00000498)=0.137526364382784E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 498 z1= 1 -.571750542403761E-04 0.000000000000000E+00 z1= 2 0.608830452749399E-03 0.000000000000000E+00 z1= 3 0.351926866380394E-04 0.000000000000000E+00 alpha(00000498)=0.000000000000000E+00 beta (00000499)=0.125765376382154E+02 gamma(00000499)=0.125765376382154E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 499 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000499)=0.000000000000000E+00 beta (00000500)=0.134666796591226E+02 gamma(00000500)=0.134666796591226E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 500 z1= 1 -.438830265510294E-05 0.000000000000000E+00 z1= 2 -.736926483856255E-03 0.000000000000000E+00 z1= 3 0.434614272584370E-04 0.000000000000000E+00 alpha(00000500)=0.000000000000000E+00 beta (00000501)=0.122973083479937E+02 gamma(00000501)=0.122973083479937E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Norm of initial Lanczos vectors= 2.201241667159866 Starting Lanczos loop 2 Lanczos iteration: 1 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal alpha(00000001)=0.000000000000000E+00 beta (00000002)=0.139836724127788E+01 gamma(00000002)=0.139836724127788E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 2 z1= 1 0.935133211296679E-06 0.000000000000000E+00 z1= 2 0.141271237459987E+01 0.000000000000000E+00 z1= 3 -.131806549869039E-05 0.000000000000000E+00 alpha(00000002)=0.000000000000000E+00 beta (00000003)=0.583919937887897E+01 gamma(00000003)=0.583919937887897E+01 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 3 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000003)=0.000000000000000E+00 beta (00000004)=0.140887256722870E+02 gamma(00000004)=0.140887256722870E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 4 z1= 1 -.664244112696250E-06 0.000000000000000E+00 z1= 2 -.471987456598808E+00 0.000000000000000E+00 z1= 3 0.539132291361814E-06 0.000000000000000E+00 alpha(00000004)=0.000000000000000E+00 beta (00000005)=0.136313899759472E+02 gamma(00000005)=0.136313899759472E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 5 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000005)=0.000000000000000E+00 beta (00000006)=0.120975531615199E+02 gamma(00000006)=0.120975531615199E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 6 z1= 1 0.940268441537717E-06 0.000000000000000E+00 z1= 2 0.472275568410778E+00 0.000000000000000E+00 z1= 3 -.587342315553426E-06 0.000000000000000E+00 alpha(00000006)=0.000000000000000E+00 beta (00000007)=0.129753668669883E+02 gamma(00000007)=0.129753668669883E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 7 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000007)=0.000000000000000E+00 beta (00000008)=0.137658456966887E+02 gamma(00000008)=0.137658456966887E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 8 z1= 1 -.103831436109800E-05 0.000000000000000E+00 z1= 2 -.420320369487410E+00 0.000000000000000E+00 z1= 3 0.510760075579739E-06 0.000000000000000E+00 alpha(00000008)=0.000000000000000E+00 beta (00000009)=0.114977151463364E+02 gamma(00000009)=0.114977151463364E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 9 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000009)=0.000000000000000E+00 beta (00000010)=0.144406510096884E+02 gamma(00000010)=0.144406510096884E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 10 z1= 1 0.903422349847818E-06 0.000000000000000E+00 z1= 2 0.320386019754696E+00 0.000000000000000E+00 z1= 3 -.532447748920759E-06 0.000000000000000E+00 alpha(00000010)=0.000000000000000E+00 beta (00000011)=0.114835123050549E+02 gamma(00000011)=0.114835123050549E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 11 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000011)=0.000000000000000E+00 beta (00000012)=0.141508615499521E+02 gamma(00000012)=0.141508615499521E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 12 z1= 1 -.805015772781074E-06 0.000000000000000E+00 z1= 2 -.249513096180337E+00 0.000000000000000E+00 z1= 3 0.499041620959659E-06 0.000000000000000E+00 alpha(00000012)=0.000000000000000E+00 beta (00000013)=0.121762969751656E+02 gamma(00000013)=0.121762969751656E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 13 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000013)=0.000000000000000E+00 beta (00000014)=0.136920620006052E+02 gamma(00000014)=0.136920620006052E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 14 z1= 1 0.709991428662037E-06 0.000000000000000E+00 z1= 2 0.214072509204877E+00 0.000000000000000E+00 z1= 3 -.538954631155173E-06 0.000000000000000E+00 alpha(00000014)=0.000000000000000E+00 beta (00000015)=0.126055048774169E+02 gamma(00000015)=0.126055048774169E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 15 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000015)=0.000000000000000E+00 beta (00000016)=0.132631114198092E+02 gamma(00000016)=0.132631114198092E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 16 z1= 1 -.698573910375318E-06 0.000000000000000E+00 z1= 2 -.197586811709332E+00 0.000000000000000E+00 z1= 3 0.509235059797681E-06 0.000000000000000E+00 alpha(00000016)=0.000000000000000E+00 beta (00000017)=0.126323164808970E+02 gamma(00000017)=0.126323164808970E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 17 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000017)=0.000000000000000E+00 beta (00000018)=0.132915258163028E+02 gamma(00000018)=0.132915258163028E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 18 z1= 1 0.816014734054960E-06 0.000000000000000E+00 z1= 2 0.183442936024253E+00 0.000000000000000E+00 z1= 3 -.810754139687073E-06 0.000000000000000E+00 alpha(00000018)=0.000000000000000E+00 beta (00000019)=0.125783963569558E+02 gamma(00000019)=0.125783963569558E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 19 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000019)=0.000000000000000E+00 beta (00000020)=0.133266313902075E+02 gamma(00000020)=0.133266313902075E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 20 z1= 1 -.500220376157927E-06 0.000000000000000E+00 z1= 2 -.169456302645367E+00 0.000000000000000E+00 z1= 3 0.590006896876915E-06 0.000000000000000E+00 alpha(00000020)=0.000000000000000E+00 beta (00000021)=0.126803210554271E+02 gamma(00000021)=0.126803210554271E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 21 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000021)=0.000000000000000E+00 beta (00000022)=0.135271588529229E+02 gamma(00000022)=0.135271588529229E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 22 z1= 1 0.783984728361213E-06 0.000000000000000E+00 z1= 2 0.155556902610307E+00 0.000000000000000E+00 z1= 3 -.258343520937549E-06 0.000000000000000E+00 alpha(00000022)=0.000000000000000E+00 beta (00000023)=0.127977391557157E+02 gamma(00000023)=0.127977391557157E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 23 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000023)=0.000000000000000E+00 beta (00000024)=0.129390609879648E+02 gamma(00000024)=0.129390609879648E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 24 z1= 1 -.123163286923269E-05 0.000000000000000E+00 z1= 2 -.150682841882157E+00 0.000000000000000E+00 z1= 3 0.829805625171976E-06 0.000000000000000E+00 alpha(00000024)=0.000000000000000E+00 beta (00000025)=0.127075510155173E+02 gamma(00000025)=0.127075510155173E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 25 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000025)=0.000000000000000E+00 beta (00000026)=0.128588694657202E+02 gamma(00000026)=0.128588694657202E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 26 z1= 1 0.436227071140896E-06 0.000000000000000E+00 z1= 2 0.146081665329210E+00 0.000000000000000E+00 z1= 3 -.331970398887121E-06 0.000000000000000E+00 alpha(00000026)=0.000000000000000E+00 beta (00000027)=0.129458723747136E+02 gamma(00000027)=0.129458723747136E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 27 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000027)=0.000000000000000E+00 beta (00000028)=0.129315203183986E+02 gamma(00000028)=0.129315203183986E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 28 z1= 1 -.748967162867223E-06 0.000000000000000E+00 z1= 2 -.143973500922301E+00 0.000000000000000E+00 z1= 3 0.156144997441317E-06 0.000000000000000E+00 alpha(00000028)=0.000000000000000E+00 beta (00000029)=0.128383631998739E+02 gamma(00000029)=0.128383631998739E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 29 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000029)=0.000000000000000E+00 beta (00000030)=0.131773510431220E+02 gamma(00000030)=0.131773510431220E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 30 z1= 1 0.183197118674028E-05 0.000000000000000E+00 z1= 2 0.138440345793649E+00 0.000000000000000E+00 z1= 3 -.819187755326037E-06 0.000000000000000E+00 alpha(00000030)=0.000000000000000E+00 beta (00000031)=0.126981919403393E+02 gamma(00000031)=0.126981919403393E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 31 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000031)=0.000000000000000E+00 beta (00000032)=0.131551602403744E+02 gamma(00000032)=0.131551602403744E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 32 z1= 1 -.109915450640513E-05 0.000000000000000E+00 z1= 2 -.132128597254262E+00 0.000000000000000E+00 z1= 3 0.441593299312353E-06 0.000000000000000E+00 alpha(00000032)=0.000000000000000E+00 beta (00000033)=0.123725443505204E+02 gamma(00000033)=0.123725443505204E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 33 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000033)=0.000000000000000E+00 beta (00000034)=0.135229031087589E+02 gamma(00000034)=0.135229031087589E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 34 z1= 1 0.915876941628459E-06 0.000000000000000E+00 z1= 2 0.119601844221028E+00 0.000000000000000E+00 z1= 3 -.955754307118469E-07 0.000000000000000E+00 alpha(00000034)=0.000000000000000E+00 beta (00000035)=0.123512675463346E+02 gamma(00000035)=0.123512675463346E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 35 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000035)=0.000000000000000E+00 beta (00000036)=0.131882262006396E+02 gamma(00000036)=0.131882262006396E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 36 z1= 1 -.161648908755460E-05 0.000000000000000E+00 z1= 2 -.110753304732721E+00 0.000000000000000E+00 z1= 3 -.217642578377499E-06 0.000000000000000E+00 alpha(00000036)=0.000000000000000E+00 beta (00000037)=0.124686340583908E+02 gamma(00000037)=0.124686340583908E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 37 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000037)=0.000000000000000E+00 beta (00000038)=0.132932954544887E+02 gamma(00000038)=0.132932954544887E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 38 z1= 1 0.254532335946037E-05 0.000000000000000E+00 z1= 2 0.102634647619805E+00 0.000000000000000E+00 z1= 3 -.132352789679975E-06 0.000000000000000E+00 alpha(00000038)=0.000000000000000E+00 beta (00000039)=0.129485069855186E+02 gamma(00000039)=0.129485069855186E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 39 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000039)=0.000000000000000E+00 beta (00000040)=0.132358085154387E+02 gamma(00000040)=0.132358085154387E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 40 z1= 1 -.267489729378640E-05 0.000000000000000E+00 z1= 2 -.992603158367057E-01 0.000000000000000E+00 z1= 3 0.774984267208796E-06 0.000000000000000E+00 alpha(00000040)=0.000000000000000E+00 beta (00000041)=0.128333431826728E+02 gamma(00000041)=0.128333431826728E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 41 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000041)=0.000000000000000E+00 beta (00000042)=0.126751977789936E+02 gamma(00000042)=0.126751977789936E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 42 z1= 1 0.292402216591631E-05 0.000000000000000E+00 z1= 2 0.993054665137221E-01 0.000000000000000E+00 z1= 3 -.111387380300290E-05 0.000000000000000E+00 alpha(00000042)=0.000000000000000E+00 beta (00000043)=0.129620821497742E+02 gamma(00000043)=0.129620821497742E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 43 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000043)=0.000000000000000E+00 beta (00000044)=0.130762801594945E+02 gamma(00000044)=0.130762801594945E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 44 z1= 1 -.280217519509941E-05 0.000000000000000E+00 z1= 2 -.973507536027222E-01 0.000000000000000E+00 z1= 3 0.285915976326080E-06 0.000000000000000E+00 alpha(00000044)=0.000000000000000E+00 beta (00000045)=0.128718030225587E+02 gamma(00000045)=0.128718030225587E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 45 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000045)=0.000000000000000E+00 beta (00000046)=0.131382610017108E+02 gamma(00000046)=0.131382610017108E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 46 z1= 1 0.342119293824696E-05 0.000000000000000E+00 z1= 2 0.944416911730495E-01 0.000000000000000E+00 z1= 3 0.193663925176016E-06 0.000000000000000E+00 alpha(00000046)=0.000000000000000E+00 beta (00000047)=0.124674450380274E+02 gamma(00000047)=0.124674450380274E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 47 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000047)=0.000000000000000E+00 beta (00000048)=0.132106703296452E+02 gamma(00000048)=0.132106703296452E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 48 z1= 1 -.440010973478365E-05 0.000000000000000E+00 z1= 2 -.886431150989993E-01 0.000000000000000E+00 z1= 3 0.377846601532774E-06 0.000000000000000E+00 alpha(00000048)=0.000000000000000E+00 beta (00000049)=0.125331439987544E+02 gamma(00000049)=0.125331439987544E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 49 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000049)=0.000000000000000E+00 beta (00000050)=0.134282209647514E+02 gamma(00000050)=0.134282209647514E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 50 z1= 1 0.419484256279287E-05 0.000000000000000E+00 z1= 2 0.826394757496030E-01 0.000000000000000E+00 z1= 3 -.172783619677500E-06 0.000000000000000E+00 alpha(00000050)=0.000000000000000E+00 beta (00000051)=0.125079661466191E+02 gamma(00000051)=0.125079661466191E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 51 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000051)=0.000000000000000E+00 beta (00000052)=0.134310781744980E+02 gamma(00000052)=0.134310781744980E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 52 z1= 1 -.406162763661681E-05 0.000000000000000E+00 z1= 2 -.771651490444487E-01 0.000000000000000E+00 z1= 3 0.582713205241232E-06 0.000000000000000E+00 alpha(00000052)=0.000000000000000E+00 beta (00000053)=0.124679934518504E+02 gamma(00000053)=0.124679934518504E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 53 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000053)=0.000000000000000E+00 beta (00000054)=0.133576588753946E+02 gamma(00000054)=0.133576588753946E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 54 z1= 1 0.255449952514530E-05 0.000000000000000E+00 z1= 2 0.723087216855334E-01 0.000000000000000E+00 z1= 3 -.489120433451191E-06 0.000000000000000E+00 alpha(00000054)=0.000000000000000E+00 beta (00000055)=0.126450806232305E+02 gamma(00000055)=0.126450806232305E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 55 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000055)=0.000000000000000E+00 beta (00000056)=0.128789373602550E+02 gamma(00000056)=0.128789373602550E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 56 z1= 1 -.209685080092411E-05 0.000000000000000E+00 z1= 2 -.716364312682185E-01 0.000000000000000E+00 z1= 3 -.263847300952186E-06 0.000000000000000E+00 alpha(00000056)=0.000000000000000E+00 beta (00000057)=0.127417983946073E+02 gamma(00000057)=0.127417983946073E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 57 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000057)=0.000000000000000E+00 beta (00000058)=0.132229284275337E+02 gamma(00000058)=0.132229284275337E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 58 z1= 1 0.196471943327654E-05 0.000000000000000E+00 z1= 2 0.698481589549977E-01 0.000000000000000E+00 z1= 3 0.540035526705104E-06 0.000000000000000E+00 alpha(00000058)=0.000000000000000E+00 beta (00000059)=0.127530561367049E+02 gamma(00000059)=0.127530561367049E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 59 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000059)=0.000000000000000E+00 beta (00000060)=0.129595968607173E+02 gamma(00000060)=0.129595968607173E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 60 z1= 1 -.182376315918057E-05 0.000000000000000E+00 z1= 2 -.698495204760384E-01 0.000000000000000E+00 z1= 3 -.111590703009078E-05 0.000000000000000E+00 alpha(00000060)=0.000000000000000E+00 beta (00000061)=0.128510420164594E+02 gamma(00000061)=0.128510420164594E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 61 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000061)=0.000000000000000E+00 beta (00000062)=0.133870206164047E+02 gamma(00000062)=0.133870206164047E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 62 z1= 1 0.106838751866810E-05 0.000000000000000E+00 z1= 2 0.679942014516386E-01 0.000000000000000E+00 z1= 3 0.154181213892011E-05 0.000000000000000E+00 alpha(00000062)=0.000000000000000E+00 beta (00000063)=0.126333789841413E+02 gamma(00000063)=0.126333789841413E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 63 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000063)=0.000000000000000E+00 beta (00000064)=0.133857610580575E+02 gamma(00000064)=0.133857610580575E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 64 z1= 1 -.186882691860166E-05 0.000000000000000E+00 z1= 2 -.648558776943642E-01 0.000000000000000E+00 z1= 3 0.333608545044473E-06 0.000000000000000E+00 alpha(00000064)=0.000000000000000E+00 beta (00000065)=0.121792272501070E+02 gamma(00000065)=0.121792272501070E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 65 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000065)=0.000000000000000E+00 beta (00000066)=0.133449698844698E+02 gamma(00000066)=0.133449698844698E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 66 z1= 1 0.308509365506623E-05 0.000000000000000E+00 z1= 2 0.593292714428874E-01 0.000000000000000E+00 z1= 3 -.150956745590888E-05 0.000000000000000E+00 alpha(00000066)=0.000000000000000E+00 beta (00000067)=0.126995301046650E+02 gamma(00000067)=0.126995301046650E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 67 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000067)=0.000000000000000E+00 beta (00000068)=0.131875889513957E+02 gamma(00000068)=0.131875889513957E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 68 z1= 1 -.234893806719781E-05 0.000000000000000E+00 z1= 2 -.564959367888667E-01 0.000000000000000E+00 z1= 3 0.569123882657348E-06 0.000000000000000E+00 alpha(00000068)=0.000000000000000E+00 beta (00000069)=0.126621941855102E+02 gamma(00000069)=0.126621941855102E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 69 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000069)=0.000000000000000E+00 beta (00000070)=0.133214373507478E+02 gamma(00000070)=0.133214373507478E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 70 z1= 1 0.312212191373208E-05 0.000000000000000E+00 z1= 2 0.525351882189805E-01 0.000000000000000E+00 z1= 3 -.201685107294809E-06 0.000000000000000E+00 alpha(00000070)=0.000000000000000E+00 beta (00000071)=0.126540020944299E+02 gamma(00000071)=0.126540020944299E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 71 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000071)=0.000000000000000E+00 beta (00000072)=0.132712246244557E+02 gamma(00000072)=0.132712246244557E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 72 z1= 1 -.314667811429550E-05 0.000000000000000E+00 z1= 2 -.486042561213674E-01 0.000000000000000E+00 z1= 3 0.171983291398644E-06 0.000000000000000E+00 alpha(00000072)=0.000000000000000E+00 beta (00000073)=0.126966951582507E+02 gamma(00000073)=0.126966951582507E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 73 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000073)=0.000000000000000E+00 beta (00000074)=0.130226270043078E+02 gamma(00000074)=0.130226270043078E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 74 z1= 1 0.391758531477146E-05 0.000000000000000E+00 z1= 2 0.455572806309310E-01 0.000000000000000E+00 z1= 3 -.796845752767256E-06 0.000000000000000E+00 alpha(00000074)=0.000000000000000E+00 beta (00000075)=0.128778731697637E+02 gamma(00000075)=0.128778731697637E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 75 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000075)=0.000000000000000E+00 beta (00000076)=0.132607068652829E+02 gamma(00000076)=0.132607068652829E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 76 z1= 1 -.455020122782030E-05 0.000000000000000E+00 z1= 2 -.425458088758189E-01 0.000000000000000E+00 z1= 3 0.111319442736832E-05 0.000000000000000E+00 alpha(00000076)=0.000000000000000E+00 beta (00000077)=0.127616309247740E+02 gamma(00000077)=0.127616309247740E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 77 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000077)=0.000000000000000E+00 beta (00000078)=0.131374046814300E+02 gamma(00000078)=0.131374046814300E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 78 z1= 1 0.535546906977203E-05 0.000000000000000E+00 z1= 2 0.395421106843526E-01 0.000000000000000E+00 z1= 3 -.836253469298004E-06 0.000000000000000E+00 alpha(00000078)=0.000000000000000E+00 beta (00000079)=0.128833007767276E+02 gamma(00000079)=0.128833007767276E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 79 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000079)=0.000000000000000E+00 beta (00000080)=0.127684264601969E+02 gamma(00000080)=0.127684264601969E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 80 z1= 1 -.857189944512490E-05 0.000000000000000E+00 z1= 2 -.384194549896494E-01 0.000000000000000E+00 z1= 3 0.191406142308493E-05 0.000000000000000E+00 alpha(00000080)=0.000000000000000E+00 beta (00000081)=0.129712148198710E+02 gamma(00000081)=0.129712148198710E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 81 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000081)=0.000000000000000E+00 beta (00000082)=0.131219928205000E+02 gamma(00000082)=0.131219928205000E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 82 z1= 1 0.109439440883711E-04 0.000000000000000E+00 z1= 2 0.369479939496412E-01 0.000000000000000E+00 z1= 3 -.386901103503127E-05 0.000000000000000E+00 alpha(00000082)=0.000000000000000E+00 beta (00000083)=0.126070435786198E+02 gamma(00000083)=0.126070435786198E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 83 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000083)=0.000000000000000E+00 beta (00000084)=0.134495335548855E+02 gamma(00000084)=0.134495335548855E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 84 z1= 1 -.118833401310768E-04 0.000000000000000E+00 z1= 2 -.338192702731376E-01 0.000000000000000E+00 z1= 3 0.447738240690011E-05 0.000000000000000E+00 alpha(00000084)=0.000000000000000E+00 beta (00000085)=0.123892495723386E+02 gamma(00000085)=0.123892495723386E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 85 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000085)=0.000000000000000E+00 beta (00000086)=0.132666300189959E+02 gamma(00000086)=0.132666300189959E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 86 z1= 1 0.127859458724389E-04 0.000000000000000E+00 z1= 2 0.309416962209079E-01 0.000000000000000E+00 z1= 3 -.526519860069628E-05 0.000000000000000E+00 alpha(00000086)=0.000000000000000E+00 beta (00000087)=0.124221989140088E+02 gamma(00000087)=0.124221989140088E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 87 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000087)=0.000000000000000E+00 beta (00000088)=0.132438286446513E+02 gamma(00000088)=0.132438286446513E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 88 z1= 1 -.138206545011507E-04 0.000000000000000E+00 z1= 2 -.286605688397890E-01 0.000000000000000E+00 z1= 3 0.606813479554899E-05 0.000000000000000E+00 alpha(00000088)=0.000000000000000E+00 beta (00000089)=0.125386933615201E+02 gamma(00000089)=0.125386933615201E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 89 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000089)=0.000000000000000E+00 beta (00000090)=0.133115521822898E+02 gamma(00000090)=0.133115521822898E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 90 z1= 1 0.148145038336815E-04 0.000000000000000E+00 z1= 2 0.269383336215990E-01 0.000000000000000E+00 z1= 3 -.617320812300033E-05 0.000000000000000E+00 alpha(00000090)=0.000000000000000E+00 beta (00000091)=0.126851075603620E+02 gamma(00000091)=0.126851075603620E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 91 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000091)=0.000000000000000E+00 beta (00000092)=0.131713697509618E+02 gamma(00000092)=0.131713697509618E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 92 z1= 1 -.173514843363597E-04 0.000000000000000E+00 z1= 2 -.258166683038667E-01 0.000000000000000E+00 z1= 3 0.642571296242196E-05 0.000000000000000E+00 alpha(00000092)=0.000000000000000E+00 beta (00000093)=0.128555906348563E+02 gamma(00000093)=0.128555906348563E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 93 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000093)=0.000000000000000E+00 beta (00000094)=0.131661327613865E+02 gamma(00000094)=0.131661327613865E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 94 z1= 1 0.160326954548231E-04 0.000000000000000E+00 z1= 2 0.248513746647125E-01 0.000000000000000E+00 z1= 3 -.501750197111144E-05 0.000000000000000E+00 alpha(00000094)=0.000000000000000E+00 beta (00000095)=0.128088672503836E+02 gamma(00000095)=0.128088672503836E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 95 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000095)=0.000000000000000E+00 beta (00000096)=0.133490397012067E+02 gamma(00000096)=0.133490397012067E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 96 z1= 1 -.133415489062920E-04 0.000000000000000E+00 z1= 2 -.234809736099655E-01 0.000000000000000E+00 z1= 3 0.292306851725681E-05 0.000000000000000E+00 alpha(00000096)=0.000000000000000E+00 beta (00000097)=0.126796695775870E+02 gamma(00000097)=0.126796695775870E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 97 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000097)=0.000000000000000E+00 beta (00000098)=0.134660830582948E+02 gamma(00000098)=0.134660830582948E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 98 z1= 1 0.115923450478006E-04 0.000000000000000E+00 z1= 2 0.222440515992408E-01 0.000000000000000E+00 z1= 3 -.181281252846304E-05 0.000000000000000E+00 alpha(00000098)=0.000000000000000E+00 beta (00000099)=0.127333679571485E+02 gamma(00000099)=0.127333679571485E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 99 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000099)=0.000000000000000E+00 beta (00000100)=0.134436742113436E+02 gamma(00000100)=0.134436742113436E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 100 z1= 1 -.108163344444343E-04 0.000000000000000E+00 z1= 2 -.215524270991079E-01 0.000000000000000E+00 z1= 3 0.108523273478940E-05 0.000000000000000E+00 alpha(00000100)=0.000000000000000E+00 beta (00000101)=0.127401096007348E+02 gamma(00000101)=0.127401096007348E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 101 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000101)=0.000000000000000E+00 beta (00000102)=0.132547391889558E+02 gamma(00000102)=0.132547391889558E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 102 z1= 1 0.100657580550789E-04 0.000000000000000E+00 z1= 2 0.211751218290351E-01 0.000000000000000E+00 z1= 3 0.477772300001812E-06 0.000000000000000E+00 alpha(00000102)=0.000000000000000E+00 beta (00000103)=0.126942395302668E+02 gamma(00000103)=0.126942395302668E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 103 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000103)=0.000000000000000E+00 beta (00000104)=0.130539499554243E+02 gamma(00000104)=0.130539499554243E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 104 z1= 1 -.784540541912473E-05 0.000000000000000E+00 z1= 2 -.204111343232817E-01 0.000000000000000E+00 z1= 3 -.173070278733812E-05 0.000000000000000E+00 alpha(00000104)=0.000000000000000E+00 beta (00000105)=0.124331480384656E+02 gamma(00000105)=0.124331480384656E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 105 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000105)=0.000000000000000E+00 beta (00000106)=0.131205891099776E+02 gamma(00000106)=0.131205891099776E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 106 z1= 1 0.545091035965457E-05 0.000000000000000E+00 z1= 2 0.185737395142171E-01 0.000000000000000E+00 z1= 3 0.245305973945408E-05 0.000000000000000E+00 alpha(00000106)=0.000000000000000E+00 beta (00000107)=0.125418466004826E+02 gamma(00000107)=0.125418466004826E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 107 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000107)=0.000000000000000E+00 beta (00000108)=0.129503919427263E+02 gamma(00000108)=0.129503919427263E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 108 z1= 1 -.394840187097761E-05 0.000000000000000E+00 z1= 2 -.166741545374193E-01 0.000000000000000E+00 z1= 3 -.371824849836570E-05 0.000000000000000E+00 alpha(00000108)=0.000000000000000E+00 beta (00000109)=0.126573468059685E+02 gamma(00000109)=0.126573468059685E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 109 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000109)=0.000000000000000E+00 beta (00000110)=0.128520599969093E+02 gamma(00000110)=0.128520599969093E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 110 z1= 1 0.469637757277014E-05 0.000000000000000E+00 z1= 2 0.147905314094316E-01 0.000000000000000E+00 z1= 3 0.247595800988284E-05 0.000000000000000E+00 alpha(00000110)=0.000000000000000E+00 beta (00000111)=0.121378515662929E+02 gamma(00000111)=0.121378515662929E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 111 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000111)=0.000000000000000E+00 beta (00000112)=0.130626740053795E+02 gamma(00000112)=0.130626740053795E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 112 z1= 1 -.464627330371134E-05 0.000000000000000E+00 z1= 2 -.125511583566596E-01 0.000000000000000E+00 z1= 3 -.207914248624290E-05 0.000000000000000E+00 alpha(00000112)=0.000000000000000E+00 beta (00000113)=0.123829343034366E+02 gamma(00000113)=0.123829343034366E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 113 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000113)=0.000000000000000E+00 beta (00000114)=0.131503830351824E+02 gamma(00000114)=0.131503830351824E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 114 z1= 1 0.696243699465022E-05 0.000000000000000E+00 z1= 2 0.110437387169488E-01 0.000000000000000E+00 z1= 3 -.226907263246878E-06 0.000000000000000E+00 alpha(00000114)=0.000000000000000E+00 beta (00000115)=0.126760547445771E+02 gamma(00000115)=0.126760547445771E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 115 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000115)=0.000000000000000E+00 beta (00000116)=0.134863311045059E+02 gamma(00000116)=0.134863311045059E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 116 z1= 1 -.971893993858175E-05 0.000000000000000E+00 z1= 2 -.991086031600594E-02 0.000000000000000E+00 z1= 3 0.269659791537731E-05 0.000000000000000E+00 alpha(00000116)=0.000000000000000E+00 beta (00000117)=0.125981600370846E+02 gamma(00000117)=0.125981600370846E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 117 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000117)=0.000000000000000E+00 beta (00000118)=0.129697064003985E+02 gamma(00000118)=0.129697064003985E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 118 z1= 1 0.149587091568203E-04 0.000000000000000E+00 z1= 2 0.976687078652930E-02 0.000000000000000E+00 z1= 3 -.635661922813752E-05 0.000000000000000E+00 alpha(00000118)=0.000000000000000E+00 beta (00000119)=0.121791466107980E+02 gamma(00000119)=0.121791466107980E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 119 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000119)=0.000000000000000E+00 beta (00000120)=0.130019108219398E+02 gamma(00000120)=0.130019108219398E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 120 z1= 1 -.185211959897141E-04 0.000000000000000E+00 z1= 2 -.926773870913753E-02 0.000000000000000E+00 z1= 3 0.100315061022888E-04 0.000000000000000E+00 alpha(00000120)=0.000000000000000E+00 beta (00000121)=0.126752339872905E+02 gamma(00000121)=0.126752339872905E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 121 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000121)=0.000000000000000E+00 beta (00000122)=0.136881279561102E+02 gamma(00000122)=0.136881279561102E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 122 z1= 1 0.251448800552712E-04 0.000000000000000E+00 z1= 2 0.861389517225015E-02 0.000000000000000E+00 z1= 3 -.144876195142941E-04 0.000000000000000E+00 alpha(00000122)=0.000000000000000E+00 beta (00000123)=0.127025702197611E+02 gamma(00000123)=0.127025702197611E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 123 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000123)=0.000000000000000E+00 beta (00000124)=0.134156383136430E+02 gamma(00000124)=0.134156383136430E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 124 z1= 1 -.296618029385319E-04 0.000000000000000E+00 z1= 2 -.825803148774217E-02 0.000000000000000E+00 z1= 3 0.163624706803321E-04 0.000000000000000E+00 alpha(00000124)=0.000000000000000E+00 beta (00000125)=0.123037921425864E+02 gamma(00000125)=0.123037921425864E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 125 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000125)=0.000000000000000E+00 beta (00000126)=0.133200383070341E+02 gamma(00000126)=0.133200383070341E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 126 z1= 1 0.366529014487675E-04 0.000000000000000E+00 z1= 2 0.778738961966170E-02 0.000000000000000E+00 z1= 3 -.207697296555398E-04 0.000000000000000E+00 alpha(00000126)=0.000000000000000E+00 beta (00000127)=0.129199437386044E+02 gamma(00000127)=0.129199437386044E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 127 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000127)=0.000000000000000E+00 beta (00000128)=0.131944572468710E+02 gamma(00000128)=0.131944572468710E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 128 z1= 1 -.448283348466524E-04 0.000000000000000E+00 z1= 2 -.805378963406080E-02 0.000000000000000E+00 z1= 3 0.255156933917178E-04 0.000000000000000E+00 alpha(00000128)=0.000000000000000E+00 beta (00000129)=0.131949017198351E+02 gamma(00000129)=0.131949017198351E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 129 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000129)=0.000000000000000E+00 beta (00000130)=0.132236327563929E+02 gamma(00000130)=0.132236327563929E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 130 z1= 1 0.506060918672099E-04 0.000000000000000E+00 z1= 2 0.834805665408986E-02 0.000000000000000E+00 z1= 3 -.291304845076405E-04 0.000000000000000E+00 alpha(00000130)=0.000000000000000E+00 beta (00000131)=0.126032332325846E+02 gamma(00000131)=0.126032332325846E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 131 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000131)=0.000000000000000E+00 beta (00000132)=0.130367522306801E+02 gamma(00000132)=0.130367522306801E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 132 z1= 1 -.569264339774465E-04 0.000000000000000E+00 z1= 2 -.824908237841669E-02 0.000000000000000E+00 z1= 3 0.321794433567628E-04 0.000000000000000E+00 alpha(00000132)=0.000000000000000E+00 beta (00000133)=0.123211927267347E+02 gamma(00000133)=0.123211927267347E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 133 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000133)=0.000000000000000E+00 beta (00000134)=0.131101399288349E+02 gamma(00000134)=0.131101399288349E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 134 z1= 1 0.621140436576698E-04 0.000000000000000E+00 z1= 2 0.775801008536424E-02 0.000000000000000E+00 z1= 3 -.347282319776391E-04 0.000000000000000E+00 alpha(00000134)=0.000000000000000E+00 beta (00000135)=0.128061605133840E+02 gamma(00000135)=0.128061605133840E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 135 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000135)=0.000000000000000E+00 beta (00000136)=0.129383418199556E+02 gamma(00000136)=0.129383418199556E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 136 z1= 1 -.699882803326338E-04 0.000000000000000E+00 z1= 2 -.769837972411724E-02 0.000000000000000E+00 z1= 3 0.392017851933985E-04 0.000000000000000E+00 alpha(00000136)=0.000000000000000E+00 beta (00000137)=0.133669840035051E+02 gamma(00000137)=0.133669840035051E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 137 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000137)=0.000000000000000E+00 beta (00000138)=0.131131928845784E+02 gamma(00000138)=0.131131928845784E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 138 z1= 1 0.749122098068471E-04 0.000000000000000E+00 z1= 2 0.815438204396619E-02 0.000000000000000E+00 z1= 3 -.425900798548964E-04 0.000000000000000E+00 alpha(00000138)=0.000000000000000E+00 beta (00000139)=0.128245287175233E+02 gamma(00000139)=0.128245287175233E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 139 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000139)=0.000000000000000E+00 beta (00000140)=0.128653384728603E+02 gamma(00000140)=0.128653384728603E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 140 z1= 1 -.794605165392523E-04 0.000000000000000E+00 z1= 2 -.836784213196172E-02 0.000000000000000E+00 z1= 3 0.441042841437343E-04 0.000000000000000E+00 alpha(00000140)=0.000000000000000E+00 beta (00000141)=0.127843208516649E+02 gamma(00000141)=0.127843208516649E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 141 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000141)=0.000000000000000E+00 beta (00000142)=0.129512934977032E+02 gamma(00000142)=0.129512934977032E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 142 z1= 1 0.828903961538150E-04 0.000000000000000E+00 z1= 2 0.802837268079658E-02 0.000000000000000E+00 z1= 3 -.444198180603971E-04 0.000000000000000E+00 alpha(00000142)=0.000000000000000E+00 beta (00000143)=0.128289123430457E+02 gamma(00000143)=0.128289123430457E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 143 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000143)=0.000000000000000E+00 beta (00000144)=0.129893451827205E+02 gamma(00000144)=0.129893451827205E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 144 z1= 1 -.874192888993125E-04 0.000000000000000E+00 z1= 2 -.740702182406084E-02 0.000000000000000E+00 z1= 3 0.484630277435947E-04 0.000000000000000E+00 alpha(00000144)=0.000000000000000E+00 beta (00000145)=0.123296534599371E+02 gamma(00000145)=0.123296534599371E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 145 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000145)=0.000000000000000E+00 beta (00000146)=0.131744336858767E+02 gamma(00000146)=0.131744336858767E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 146 z1= 1 0.895990869216289E-04 0.000000000000000E+00 z1= 2 0.615636001465407E-02 0.000000000000000E+00 z1= 3 -.487706394989091E-04 0.000000000000000E+00 alpha(00000146)=0.000000000000000E+00 beta (00000147)=0.126256526033079E+02 gamma(00000147)=0.126256526033079E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 147 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000147)=0.000000000000000E+00 beta (00000148)=0.130078979547476E+02 gamma(00000148)=0.130078979547476E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 148 z1= 1 -.926196891888730E-04 0.000000000000000E+00 z1= 2 -.550668945002451E-02 0.000000000000000E+00 z1= 3 0.484414648326013E-04 0.000000000000000E+00 alpha(00000148)=0.000000000000000E+00 beta (00000149)=0.129825780450270E+02 gamma(00000149)=0.129825780450270E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 149 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000149)=0.000000000000000E+00 beta (00000150)=0.132681149079751E+02 gamma(00000150)=0.132681149079751E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 150 z1= 1 0.969599304083482E-04 0.000000000000000E+00 z1= 2 0.562287538624160E-02 0.000000000000000E+00 z1= 3 -.500432851693549E-04 0.000000000000000E+00 alpha(00000150)=0.000000000000000E+00 beta (00000151)=0.129562580976908E+02 gamma(00000151)=0.129562580976908E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 151 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000151)=0.000000000000000E+00 beta (00000152)=0.129462154748532E+02 gamma(00000152)=0.129462154748532E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 152 z1= 1 -.104307126634097E-03 0.000000000000000E+00 z1= 2 -.631910248727479E-02 0.000000000000000E+00 z1= 3 0.546321115336809E-04 0.000000000000000E+00 alpha(00000152)=0.000000000000000E+00 beta (00000153)=0.128938993243810E+02 gamma(00000153)=0.128938993243810E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 153 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000153)=0.000000000000000E+00 beta (00000154)=0.130453730970385E+02 gamma(00000154)=0.130453730970385E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 154 z1= 1 0.111378527438547E-03 0.000000000000000E+00 z1= 2 0.704044963683297E-02 0.000000000000000E+00 z1= 3 -.579561515492697E-04 0.000000000000000E+00 alpha(00000154)=0.000000000000000E+00 beta (00000155)=0.128405662629026E+02 gamma(00000155)=0.128405662629026E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 155 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000155)=0.000000000000000E+00 beta (00000156)=0.130686396177168E+02 gamma(00000156)=0.130686396177168E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 156 z1= 1 -.114911421141806E-03 0.000000000000000E+00 z1= 2 -.777252917560271E-02 0.000000000000000E+00 z1= 3 0.587263459432284E-04 0.000000000000000E+00 alpha(00000156)=0.000000000000000E+00 beta (00000157)=0.122326005498406E+02 gamma(00000157)=0.122326005498406E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 157 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000157)=0.000000000000000E+00 beta (00000158)=0.134999368463584E+02 gamma(00000158)=0.134999368463584E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 158 z1= 1 0.109620456795003E-03 0.000000000000000E+00 z1= 2 0.795277986429691E-02 0.000000000000000E+00 z1= 3 -.553829944493099E-04 0.000000000000000E+00 alpha(00000158)=0.000000000000000E+00 beta (00000159)=0.122556810704207E+02 gamma(00000159)=0.122556810704207E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 159 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000159)=0.000000000000000E+00 beta (00000160)=0.132782544406752E+02 gamma(00000160)=0.132782544406752E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 160 z1= 1 -.106783877808408E-03 0.000000000000000E+00 z1= 2 -.850648428134300E-02 0.000000000000000E+00 z1= 3 0.545899918116596E-04 0.000000000000000E+00 alpha(00000160)=0.000000000000000E+00 beta (00000161)=0.125849206982158E+02 gamma(00000161)=0.125849206982158E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 161 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000161)=0.000000000000000E+00 beta (00000162)=0.130975811327033E+02 gamma(00000162)=0.130975811327033E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 162 z1= 1 0.108624127334897E-03 0.000000000000000E+00 z1= 2 0.940150566040397E-02 0.000000000000000E+00 z1= 3 -.559806457529118E-04 0.000000000000000E+00 alpha(00000162)=0.000000000000000E+00 beta (00000163)=0.128512850074629E+02 gamma(00000163)=0.128512850074629E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 163 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000163)=0.000000000000000E+00 beta (00000164)=0.128968351815618E+02 gamma(00000164)=0.128968351815618E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 164 z1= 1 -.113915396820178E-03 0.000000000000000E+00 z1= 2 -.103901084001920E-01 0.000000000000000E+00 z1= 3 0.577488475115206E-04 0.000000000000000E+00 alpha(00000164)=0.000000000000000E+00 beta (00000165)=0.127262843165224E+02 gamma(00000165)=0.127262843165224E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 165 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000165)=0.000000000000000E+00 beta (00000166)=0.132449937441069E+02 gamma(00000166)=0.132449937441069E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 166 z1= 1 0.111560435382301E-03 0.000000000000000E+00 z1= 2 0.107940532941582E-01 0.000000000000000E+00 z1= 3 -.561868038710946E-04 0.000000000000000E+00 alpha(00000166)=0.000000000000000E+00 beta (00000167)=0.129449055267437E+02 gamma(00000167)=0.129449055267437E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 167 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000167)=0.000000000000000E+00 beta (00000168)=0.133166406147526E+02 gamma(00000168)=0.133166406147526E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 168 z1= 1 -.111896618501896E-03 0.000000000000000E+00 z1= 2 -.112664695386107E-01 0.000000000000000E+00 z1= 3 0.550922177392438E-04 0.000000000000000E+00 alpha(00000168)=0.000000000000000E+00 beta (00000169)=0.125924251775986E+02 gamma(00000169)=0.125924251775986E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 169 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000169)=0.000000000000000E+00 beta (00000170)=0.133601564952792E+02 gamma(00000170)=0.133601564952792E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 170 z1= 1 0.113015091515157E-03 0.000000000000000E+00 z1= 2 0.113717606291404E-01 0.000000000000000E+00 z1= 3 -.545831101999360E-04 0.000000000000000E+00 alpha(00000170)=0.000000000000000E+00 beta (00000171)=0.125389115627001E+02 gamma(00000171)=0.125389115627001E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 171 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000171)=0.000000000000000E+00 beta (00000172)=0.131769486463430E+02 gamma(00000172)=0.131769486463430E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 172 z1= 1 -.114471511971219E-03 0.000000000000000E+00 z1= 2 -.112409349221713E-01 0.000000000000000E+00 z1= 3 0.541201971451791E-04 0.000000000000000E+00 alpha(00000172)=0.000000000000000E+00 beta (00000173)=0.125214279831994E+02 gamma(00000173)=0.125214279831994E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 173 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000173)=0.000000000000000E+00 beta (00000174)=0.126803581284872E+02 gamma(00000174)=0.126803581284872E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 174 z1= 1 0.121437662011656E-03 0.000000000000000E+00 z1= 2 0.111210467032650E-01 0.000000000000000E+00 z1= 3 -.557597215480147E-04 0.000000000000000E+00 alpha(00000174)=0.000000000000000E+00 beta (00000175)=0.126874162797087E+02 gamma(00000175)=0.126874162797087E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 175 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000175)=0.000000000000000E+00 beta (00000176)=0.131961912595993E+02 gamma(00000176)=0.131961912595993E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 176 z1= 1 -.122389081311569E-03 0.000000000000000E+00 z1= 2 -.102163050192381E-01 0.000000000000000E+00 z1= 3 0.547965773183751E-04 0.000000000000000E+00 alpha(00000176)=0.000000000000000E+00 beta (00000177)=0.129360030686605E+02 gamma(00000177)=0.129360030686605E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 177 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000177)=0.000000000000000E+00 beta (00000178)=0.131378407709786E+02 gamma(00000178)=0.131378407709786E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 178 z1= 1 0.127752455178775E-03 0.000000000000000E+00 z1= 2 0.970370209802570E-02 0.000000000000000E+00 z1= 3 -.563936012662264E-04 0.000000000000000E+00 alpha(00000178)=0.000000000000000E+00 beta (00000179)=0.127171576614924E+02 gamma(00000179)=0.127171576614924E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 179 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000179)=0.000000000000000E+00 beta (00000180)=0.134841591995940E+02 gamma(00000180)=0.134841591995940E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 180 z1= 1 -.129216506250966E-03 0.000000000000000E+00 z1= 2 -.923282680331090E-02 0.000000000000000E+00 z1= 3 0.568437886994061E-04 0.000000000000000E+00 alpha(00000180)=0.000000000000000E+00 beta (00000181)=0.126267307283705E+02 gamma(00000181)=0.126267307283705E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 181 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000181)=0.000000000000000E+00 beta (00000182)=0.131750753371962E+02 gamma(00000182)=0.131750753371962E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 182 z1= 1 0.132195090365033E-03 0.000000000000000E+00 z1= 2 0.922797728572214E-02 0.000000000000000E+00 z1= 3 -.557295888898115E-04 0.000000000000000E+00 alpha(00000182)=0.000000000000000E+00 beta (00000183)=0.125210684667102E+02 gamma(00000183)=0.125210684667102E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 183 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000183)=0.000000000000000E+00 beta (00000184)=0.132582100343763E+02 gamma(00000184)=0.132582100343763E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 184 z1= 1 -.134684715527567E-03 0.000000000000000E+00 z1= 2 -.925922402297304E-02 0.000000000000000E+00 z1= 3 0.568684566319020E-04 0.000000000000000E+00 alpha(00000184)=0.000000000000000E+00 beta (00000185)=0.126476048758579E+02 gamma(00000185)=0.126476048758579E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 185 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000185)=0.000000000000000E+00 beta (00000186)=0.135763417881634E+02 gamma(00000186)=0.135763417881634E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 186 z1= 1 0.131909295963748E-03 0.000000000000000E+00 z1= 2 0.901418978680812E-02 0.000000000000000E+00 z1= 3 -.560758308289059E-04 0.000000000000000E+00 alpha(00000186)=0.000000000000000E+00 beta (00000187)=0.130517490083022E+02 gamma(00000187)=0.130517490083022E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 187 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000187)=0.000000000000000E+00 beta (00000188)=0.129650822749345E+02 gamma(00000188)=0.129650822749345E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 188 z1= 1 -.144090924305954E-03 0.000000000000000E+00 z1= 2 -.942981972007732E-02 0.000000000000000E+00 z1= 3 0.623206840947206E-04 0.000000000000000E+00 alpha(00000188)=0.000000000000000E+00 beta (00000189)=0.127178074750586E+02 gamma(00000189)=0.127178074750586E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 189 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000189)=0.000000000000000E+00 beta (00000190)=0.131135570756448E+02 gamma(00000190)=0.131135570756448E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 190 z1= 1 0.147441543497846E-03 0.000000000000000E+00 z1= 2 0.950464338936297E-02 0.000000000000000E+00 z1= 3 -.652118772323415E-04 0.000000000000000E+00 alpha(00000190)=0.000000000000000E+00 beta (00000191)=0.126219386515891E+02 gamma(00000191)=0.126219386515891E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 191 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000191)=0.000000000000000E+00 beta (00000192)=0.132254974457809E+02 gamma(00000192)=0.132254974457809E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 192 z1= 1 -.151041723489677E-03 0.000000000000000E+00 z1= 2 -.925118175383036E-02 0.000000000000000E+00 z1= 3 0.665116918990966E-04 0.000000000000000E+00 alpha(00000192)=0.000000000000000E+00 beta (00000193)=0.124935399716506E+02 gamma(00000193)=0.124935399716506E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 193 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000193)=0.000000000000000E+00 beta (00000194)=0.131699068190192E+02 gamma(00000194)=0.131699068190192E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 194 z1= 1 0.151817241787557E-03 0.000000000000000E+00 z1= 2 0.862920745640281E-02 0.000000000000000E+00 z1= 3 -.655735914381387E-04 0.000000000000000E+00 alpha(00000194)=0.000000000000000E+00 beta (00000195)=0.124690616896381E+02 gamma(00000195)=0.124690616896381E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 195 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000195)=0.000000000000000E+00 beta (00000196)=0.132547008955700E+02 gamma(00000196)=0.132547008955700E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 196 z1= 1 -.152142984753162E-03 0.000000000000000E+00 z1= 2 -.785238768199063E-02 0.000000000000000E+00 z1= 3 0.670063384309797E-04 0.000000000000000E+00 alpha(00000196)=0.000000000000000E+00 beta (00000197)=0.119625465724772E+02 gamma(00000197)=0.119625465724772E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 197 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000197)=0.000000000000000E+00 beta (00000198)=0.130600577426310E+02 gamma(00000198)=0.130600577426310E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 198 z1= 1 0.148940742873922E-03 0.000000000000000E+00 z1= 2 0.739785088386981E-02 0.000000000000000E+00 z1= 3 -.638529879306694E-04 0.000000000000000E+00 alpha(00000198)=0.000000000000000E+00 beta (00000199)=0.127718251845063E+02 gamma(00000199)=0.127718251845063E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 199 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000199)=0.000000000000000E+00 beta (00000200)=0.131477589481514E+02 gamma(00000200)=0.131477589481514E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 200 z1= 1 -.150693073490793E-03 0.000000000000000E+00 z1= 2 -.797105433463782E-02 0.000000000000000E+00 z1= 3 0.631444498233991E-04 0.000000000000000E+00 alpha(00000200)=0.000000000000000E+00 beta (00000201)=0.128033141436837E+02 gamma(00000201)=0.128033141436837E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 201 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000201)=0.000000000000000E+00 beta (00000202)=0.132812763406209E+02 gamma(00000202)=0.132812763406209E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 202 z1= 1 0.153657525973214E-03 0.000000000000000E+00 z1= 2 0.872865793478460E-02 0.000000000000000E+00 z1= 3 -.613898655141303E-04 0.000000000000000E+00 alpha(00000202)=0.000000000000000E+00 beta (00000203)=0.128104875831044E+02 gamma(00000203)=0.128104875831044E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 203 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000203)=0.000000000000000E+00 beta (00000204)=0.128422029569054E+02 gamma(00000204)=0.128422029569054E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 204 z1= 1 -.157670946794048E-03 0.000000000000000E+00 z1= 2 -.937576900724314E-02 0.000000000000000E+00 z1= 3 0.591363012524173E-04 0.000000000000000E+00 alpha(00000204)=0.000000000000000E+00 beta (00000205)=0.124879636778212E+02 gamma(00000205)=0.124879636778212E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 205 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000205)=0.000000000000000E+00 beta (00000206)=0.131223584061976E+02 gamma(00000206)=0.131223584061976E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 206 z1= 1 0.157147927760206E-03 0.000000000000000E+00 z1= 2 0.917105855906973E-02 0.000000000000000E+00 z1= 3 -.561484105397934E-04 0.000000000000000E+00 alpha(00000206)=0.000000000000000E+00 beta (00000207)=0.128718304874492E+02 gamma(00000207)=0.128718304874492E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 207 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000207)=0.000000000000000E+00 beta (00000208)=0.130434694505093E+02 gamma(00000208)=0.130434694505093E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 208 z1= 1 -.161107274088679E-03 0.000000000000000E+00 z1= 2 -.871096813438723E-02 0.000000000000000E+00 z1= 3 0.542741522791115E-04 0.000000000000000E+00 alpha(00000208)=0.000000000000000E+00 beta (00000209)=0.128238090173674E+02 gamma(00000209)=0.128238090173674E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 209 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000209)=0.000000000000000E+00 beta (00000210)=0.136527784694479E+02 gamma(00000210)=0.136527784694479E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 210 z1= 1 0.156591544823319E-03 0.000000000000000E+00 z1= 2 0.755367779577348E-02 0.000000000000000E+00 z1= 3 -.513965771778769E-04 0.000000000000000E+00 alpha(00000210)=0.000000000000000E+00 beta (00000211)=0.130611494553134E+02 gamma(00000211)=0.130611494553134E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 211 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000211)=0.000000000000000E+00 beta (00000212)=0.130368845865875E+02 gamma(00000212)=0.130368845865875E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 212 z1= 1 -.161292052923091E-03 0.000000000000000E+00 z1= 2 -.709973781725137E-02 0.000000000000000E+00 z1= 3 0.490859386241824E-04 0.000000000000000E+00 alpha(00000212)=0.000000000000000E+00 beta (00000213)=0.125424777398466E+02 gamma(00000213)=0.125424777398466E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 213 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000213)=0.000000000000000E+00 beta (00000214)=0.134481205083564E+02 gamma(00000214)=0.134481205083564E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 214 z1= 1 0.159141109354760E-03 0.000000000000000E+00 z1= 2 0.639161672276863E-02 0.000000000000000E+00 z1= 3 -.463462584436176E-04 0.000000000000000E+00 alpha(00000214)=0.000000000000000E+00 beta (00000215)=0.126325369254125E+02 gamma(00000215)=0.126325369254125E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 215 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000215)=0.000000000000000E+00 beta (00000216)=0.130188933257726E+02 gamma(00000216)=0.130188933257726E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 216 z1= 1 -.159450677915513E-03 0.000000000000000E+00 z1= 2 -.622121094221943E-02 0.000000000000000E+00 z1= 3 0.436429900157504E-04 0.000000000000000E+00 alpha(00000216)=0.000000000000000E+00 beta (00000217)=0.132501495942172E+02 gamma(00000217)=0.132501495942172E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 217 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000217)=0.000000000000000E+00 beta (00000218)=0.130077064365238E+02 gamma(00000218)=0.130077064365238E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 218 z1= 1 0.166729592680522E-03 0.000000000000000E+00 z1= 2 0.620979560713666E-02 0.000000000000000E+00 z1= 3 -.455798262439770E-04 0.000000000000000E+00 alpha(00000218)=0.000000000000000E+00 beta (00000219)=0.122654007657599E+02 gamma(00000219)=0.122654007657599E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 219 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000219)=0.000000000000000E+00 beta (00000220)=0.131200658217195E+02 gamma(00000220)=0.131200658217195E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 220 z1= 1 -.159071148008565E-03 0.000000000000000E+00 z1= 2 -.587718144825001E-02 0.000000000000000E+00 z1= 3 0.431826505023185E-04 0.000000000000000E+00 alpha(00000220)=0.000000000000000E+00 beta (00000221)=0.118766787412657E+02 gamma(00000221)=0.118766787412657E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 221 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000221)=0.000000000000000E+00 beta (00000222)=0.131096111784006E+02 gamma(00000222)=0.131096111784006E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 222 z1= 1 0.147108404923726E-03 0.000000000000000E+00 z1= 2 0.565572715599348E-02 0.000000000000000E+00 z1= 3 -.386075835366166E-04 0.000000000000000E+00 alpha(00000222)=0.000000000000000E+00 beta (00000223)=0.127505154254814E+02 gamma(00000223)=0.127505154254814E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 223 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000223)=0.000000000000000E+00 beta (00000224)=0.138166151641516E+02 gamma(00000224)=0.138166151641516E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 224 z1= 1 -.139401531154939E-03 0.000000000000000E+00 z1= 2 -.531429283894121E-02 0.000000000000000E+00 z1= 3 0.358086348604213E-04 0.000000000000000E+00 alpha(00000224)=0.000000000000000E+00 beta (00000225)=0.125340849785703E+02 gamma(00000225)=0.125340849785703E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 225 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000225)=0.000000000000000E+00 beta (00000226)=0.128466082448255E+02 gamma(00000226)=0.128466082448255E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 226 z1= 1 0.141917820961928E-03 0.000000000000000E+00 z1= 2 0.477961440151655E-02 0.000000000000000E+00 z1= 3 -.349574863025002E-04 0.000000000000000E+00 alpha(00000226)=0.000000000000000E+00 beta (00000227)=0.125203207378748E+02 gamma(00000227)=0.125203207378748E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 227 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000227)=0.000000000000000E+00 beta (00000228)=0.129103802763139E+02 gamma(00000228)=0.129103802763139E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 228 z1= 1 -.135900316484958E-03 0.000000000000000E+00 z1= 2 -.381083402243187E-02 0.000000000000000E+00 z1= 3 0.314490230253493E-04 0.000000000000000E+00 alpha(00000228)=0.000000000000000E+00 beta (00000229)=0.125623807012471E+02 gamma(00000229)=0.125623807012471E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 229 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000229)=0.000000000000000E+00 beta (00000230)=0.130890408927152E+02 gamma(00000230)=0.130890408927152E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 230 z1= 1 0.129218972050696E-03 0.000000000000000E+00 z1= 2 0.308004013244454E-02 0.000000000000000E+00 z1= 3 -.281220797935768E-04 0.000000000000000E+00 alpha(00000230)=0.000000000000000E+00 beta (00000231)=0.129229603753393E+02 gamma(00000231)=0.129229603753393E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 231 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000231)=0.000000000000000E+00 beta (00000232)=0.137484180119552E+02 gamma(00000232)=0.137484180119552E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 232 z1= 1 -.124584257646216E-03 0.000000000000000E+00 z1= 2 -.261658238215868E-02 0.000000000000000E+00 z1= 3 0.296472577900661E-04 0.000000000000000E+00 alpha(00000232)=0.000000000000000E+00 beta (00000233)=0.126127978034913E+02 gamma(00000233)=0.126127978034913E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 233 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000233)=0.000000000000000E+00 beta (00000234)=0.134175033859036E+02 gamma(00000234)=0.134175033859036E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 234 z1= 1 0.116528922376823E-03 0.000000000000000E+00 z1= 2 0.237031833895284E-02 0.000000000000000E+00 z1= 3 -.258934377341232E-04 0.000000000000000E+00 alpha(00000234)=0.000000000000000E+00 beta (00000235)=0.127942084874752E+02 gamma(00000235)=0.127942084874752E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 235 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000235)=0.000000000000000E+00 beta (00000236)=0.127056454054255E+02 gamma(00000236)=0.127056454054255E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 236 z1= 1 -.114660681197431E-03 0.000000000000000E+00 z1= 2 -.227378180373791E-02 0.000000000000000E+00 z1= 3 0.231485217348849E-04 0.000000000000000E+00 alpha(00000236)=0.000000000000000E+00 beta (00000237)=0.123821222093527E+02 gamma(00000237)=0.123821222093527E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 237 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000237)=0.000000000000000E+00 beta (00000238)=0.136557967545425E+02 gamma(00000238)=0.136557967545425E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 238 z1= 1 0.980377846317663E-04 0.000000000000000E+00 z1= 2 0.172364635262953E-02 0.000000000000000E+00 z1= 3 -.162258327459213E-04 0.000000000000000E+00 alpha(00000238)=0.000000000000000E+00 beta (00000239)=0.128811157139933E+02 gamma(00000239)=0.128811157139933E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 239 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000239)=0.000000000000000E+00 beta (00000240)=0.138403337471489E+02 gamma(00000240)=0.138403337471489E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 240 z1= 1 -.868978911603667E-04 0.000000000000000E+00 z1= 2 -.118328040510861E-02 0.000000000000000E+00 z1= 3 0.116106911189100E-04 0.000000000000000E+00 alpha(00000240)=0.000000000000000E+00 beta (00000241)=0.127292674423978E+02 gamma(00000241)=0.127292674423978E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 241 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000241)=0.000000000000000E+00 beta (00000242)=0.133259414776787E+02 gamma(00000242)=0.133259414776787E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 242 z1= 1 0.826908050727514E-04 0.000000000000000E+00 z1= 2 0.891465498643931E-03 0.000000000000000E+00 z1= 3 -.112672052572666E-04 0.000000000000000E+00 alpha(00000242)=0.000000000000000E+00 beta (00000243)=0.120547467175331E+02 gamma(00000243)=0.120547467175331E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 243 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000243)=0.000000000000000E+00 beta (00000244)=0.133254429524034E+02 gamma(00000244)=0.133254429524034E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 244 z1= 1 -.719108400973369E-04 0.000000000000000E+00 z1= 2 -.817909469722954E-03 0.000000000000000E+00 z1= 3 0.980459313091057E-05 0.000000000000000E+00 alpha(00000244)=0.000000000000000E+00 beta (00000245)=0.123571098281245E+02 gamma(00000245)=0.123571098281245E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 245 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000245)=0.000000000000000E+00 beta (00000246)=0.132345397328321E+02 gamma(00000246)=0.132345397328321E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 246 z1= 1 0.650766751859010E-04 0.000000000000000E+00 z1= 2 0.806288203067357E-03 0.000000000000000E+00 z1= 3 -.737741910710897E-05 0.000000000000000E+00 alpha(00000246)=0.000000000000000E+00 beta (00000247)=0.124223646947609E+02 gamma(00000247)=0.124223646947609E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 247 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000247)=0.000000000000000E+00 beta (00000248)=0.131600664295274E+02 gamma(00000248)=0.131600664295274E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 248 z1= 1 -.554831530498257E-04 0.000000000000000E+00 z1= 2 -.922259991348429E-03 0.000000000000000E+00 z1= 3 0.371290293370839E-05 0.000000000000000E+00 alpha(00000248)=0.000000000000000E+00 beta (00000249)=0.128130812441248E+02 gamma(00000249)=0.128130812441248E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 249 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000249)=0.000000000000000E+00 beta (00000250)=0.130169958208690E+02 gamma(00000250)=0.130169958208690E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 250 z1= 1 0.607215716397838E-04 0.000000000000000E+00 z1= 2 0.146514632367828E-02 0.000000000000000E+00 z1= 3 -.783661530736821E-05 0.000000000000000E+00 alpha(00000250)=0.000000000000000E+00 beta (00000251)=0.124722919796336E+02 gamma(00000251)=0.124722919796336E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 251 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000251)=0.000000000000000E+00 beta (00000252)=0.130939513297701E+02 gamma(00000252)=0.130939513297701E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 252 z1= 1 -.536286875056210E-04 0.000000000000000E+00 z1= 2 -.235811378350502E-02 0.000000000000000E+00 z1= 3 0.197157792079469E-05 0.000000000000000E+00 alpha(00000252)=0.000000000000000E+00 beta (00000253)=0.119065245163744E+02 gamma(00000253)=0.119065245163744E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 253 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000253)=0.000000000000000E+00 beta (00000254)=0.132122311528222E+02 gamma(00000254)=0.132122311528222E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 254 z1= 1 0.557343310556386E-04 0.000000000000000E+00 z1= 2 0.340770927044545E-02 0.000000000000000E+00 z1= 3 -.666424758420810E-05 0.000000000000000E+00 alpha(00000254)=0.000000000000000E+00 beta (00000255)=0.124619189024035E+02 gamma(00000255)=0.124619189024035E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 255 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000255)=0.000000000000000E+00 beta (00000256)=0.133423979394963E+02 gamma(00000256)=0.133423979394963E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 256 z1= 1 -.476426022902364E-04 0.000000000000000E+00 z1= 2 -.450483874052282E-02 0.000000000000000E+00 z1= 3 -.304063439270314E-05 0.000000000000000E+00 alpha(00000256)=0.000000000000000E+00 beta (00000257)=0.126903886443668E+02 gamma(00000257)=0.126903886443668E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 257 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000257)=0.000000000000000E+00 beta (00000258)=0.128766345068577E+02 gamma(00000258)=0.128766345068577E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 258 z1= 1 0.517511072115882E-04 0.000000000000000E+00 z1= 2 0.557190497893204E-02 0.000000000000000E+00 z1= 3 0.125654815907162E-05 0.000000000000000E+00 alpha(00000258)=0.000000000000000E+00 beta (00000259)=0.125186934619441E+02 gamma(00000259)=0.125186934619441E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 259 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000259)=0.000000000000000E+00 beta (00000260)=0.131939547342547E+02 gamma(00000260)=0.131939547342547E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 260 z1= 1 -.417659529897288E-04 0.000000000000000E+00 z1= 2 -.594606939954020E-02 0.000000000000000E+00 z1= 3 -.923788480431965E-05 0.000000000000000E+00 alpha(00000260)=0.000000000000000E+00 beta (00000261)=0.122880940808452E+02 gamma(00000261)=0.122880940808452E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 261 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000261)=0.000000000000000E+00 beta (00000262)=0.137471619649675E+02 gamma(00000262)=0.137471619649675E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 262 z1= 1 0.426682902204753E-04 0.000000000000000E+00 z1= 2 0.530393018461249E-02 0.000000000000000E+00 z1= 3 0.818085662554420E-05 0.000000000000000E+00 alpha(00000262)=0.000000000000000E+00 beta (00000263)=0.126741421819099E+02 gamma(00000263)=0.126741421819099E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 263 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000263)=0.000000000000000E+00 beta (00000264)=0.130556159655329E+02 gamma(00000264)=0.130556159655329E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 264 z1= 1 -.295776336777642E-04 0.000000000000000E+00 z1= 2 -.469946662450995E-02 0.000000000000000E+00 z1= 3 -.214339235047816E-04 0.000000000000000E+00 alpha(00000264)=0.000000000000000E+00 beta (00000265)=0.129568514737332E+02 gamma(00000265)=0.129568514737332E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 265 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000265)=0.000000000000000E+00 beta (00000266)=0.133975251448873E+02 gamma(00000266)=0.133975251448873E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 266 z1= 1 0.312654069960562E-04 0.000000000000000E+00 z1= 2 0.398632523099435E-02 0.000000000000000E+00 z1= 3 0.216180415202905E-04 0.000000000000000E+00 alpha(00000266)=0.000000000000000E+00 beta (00000267)=0.124016255375995E+02 gamma(00000267)=0.124016255375995E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 267 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000267)=0.000000000000000E+00 beta (00000268)=0.131854412085335E+02 gamma(00000268)=0.131854412085335E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 268 z1= 1 -.173100416237040E-04 0.000000000000000E+00 z1= 2 -.341401532691381E-02 0.000000000000000E+00 z1= 3 -.340606848202289E-04 0.000000000000000E+00 alpha(00000268)=0.000000000000000E+00 beta (00000269)=0.119891773238870E+02 gamma(00000269)=0.119891773238870E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 269 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000269)=0.000000000000000E+00 beta (00000270)=0.130684083204496E+02 gamma(00000270)=0.130684083204496E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 270 z1= 1 0.100159685600303E-04 0.000000000000000E+00 z1= 2 0.327309657853073E-02 0.000000000000000E+00 z1= 3 0.380100846011708E-04 0.000000000000000E+00 alpha(00000270)=0.000000000000000E+00 beta (00000271)=0.130863480693497E+02 gamma(00000271)=0.130863480693497E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 271 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000271)=0.000000000000000E+00 beta (00000272)=0.134548255412769E+02 gamma(00000272)=0.134548255412769E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 272 z1= 1 -.170052378534527E-06 0.000000000000000E+00 z1= 2 -.351109700352439E-02 0.000000000000000E+00 z1= 3 -.488361794556599E-04 0.000000000000000E+00 alpha(00000272)=0.000000000000000E+00 beta (00000273)=0.125025033841764E+02 gamma(00000273)=0.125025033841764E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 273 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000273)=0.000000000000000E+00 beta (00000274)=0.126451144717803E+02 gamma(00000274)=0.126451144717803E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 274 z1= 1 -.138519093660899E-04 0.000000000000000E+00 z1= 2 0.395231028676979E-02 0.000000000000000E+00 z1= 3 0.597853595239188E-04 0.000000000000000E+00 alpha(00000274)=0.000000000000000E+00 beta (00000275)=0.127286800972752E+02 gamma(00000275)=0.127286800972752E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 275 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000275)=0.000000000000000E+00 beta (00000276)=0.131711507605503E+02 gamma(00000276)=0.131711507605503E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 276 z1= 1 0.176851285878998E-04 0.000000000000000E+00 z1= 2 -.431873745404968E-02 0.000000000000000E+00 z1= 3 -.601423924303954E-04 0.000000000000000E+00 alpha(00000276)=0.000000000000000E+00 beta (00000277)=0.131552177788724E+02 gamma(00000277)=0.131552177788724E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 277 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000277)=0.000000000000000E+00 beta (00000278)=0.130679456103958E+02 gamma(00000278)=0.130679456103958E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 278 z1= 1 -.321404106800333E-04 0.000000000000000E+00 z1= 2 0.474090222581979E-02 0.000000000000000E+00 z1= 3 0.714763350572186E-04 0.000000000000000E+00 alpha(00000278)=0.000000000000000E+00 beta (00000279)=0.126453991928239E+02 gamma(00000279)=0.126453991928239E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 279 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000279)=0.000000000000000E+00 beta (00000280)=0.135248862899242E+02 gamma(00000280)=0.135248862899242E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 280 z1= 1 0.287841301294615E-04 0.000000000000000E+00 z1= 2 -.503544234491958E-02 0.000000000000000E+00 z1= 3 -.685921782262060E-04 0.000000000000000E+00 alpha(00000280)=0.000000000000000E+00 beta (00000281)=0.126343276579198E+02 gamma(00000281)=0.126343276579198E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 281 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000281)=0.000000000000000E+00 beta (00000282)=0.132703493843124E+02 gamma(00000282)=0.132703493843124E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 282 z1= 1 -.450141371457942E-04 0.000000000000000E+00 z1= 2 0.574521635013618E-02 0.000000000000000E+00 z1= 3 0.786895222086484E-04 0.000000000000000E+00 alpha(00000282)=0.000000000000000E+00 beta (00000283)=0.121729197185684E+02 gamma(00000283)=0.121729197185684E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 283 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000283)=0.000000000000000E+00 beta (00000284)=0.135188110878862E+02 gamma(00000284)=0.135188110878862E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 284 z1= 1 0.363321981112150E-04 0.000000000000000E+00 z1= 2 -.631033537403909E-02 0.000000000000000E+00 z1= 3 -.714965670906132E-04 0.000000000000000E+00 alpha(00000284)=0.000000000000000E+00 beta (00000285)=0.126718310977313E+02 gamma(00000285)=0.126718310977313E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 285 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000285)=0.000000000000000E+00 beta (00000286)=0.134131719593209E+02 gamma(00000286)=0.134131719593209E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 286 z1= 1 -.477062502024731E-04 0.000000000000000E+00 z1= 2 0.706966982669782E-02 0.000000000000000E+00 z1= 3 0.732039973497095E-04 0.000000000000000E+00 alpha(00000286)=0.000000000000000E+00 beta (00000287)=0.121001583678736E+02 gamma(00000287)=0.121001583678736E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 287 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000287)=0.000000000000000E+00 beta (00000288)=0.134071702076705E+02 gamma(00000288)=0.134071702076705E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 288 z1= 1 0.404005935653994E-04 0.000000000000000E+00 z1= 2 -.717881095995648E-02 0.000000000000000E+00 z1= 3 -.678477186233692E-04 0.000000000000000E+00 alpha(00000288)=0.000000000000000E+00 beta (00000289)=0.124509640865743E+02 gamma(00000289)=0.124509640865743E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 289 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000289)=0.000000000000000E+00 beta (00000290)=0.134109713283159E+02 gamma(00000290)=0.134109713283159E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 290 z1= 1 -.558462798567628E-04 0.000000000000000E+00 z1= 2 0.745639118852363E-02 0.000000000000000E+00 z1= 3 0.711730498559987E-04 0.000000000000000E+00 alpha(00000290)=0.000000000000000E+00 beta (00000291)=0.127570346293885E+02 gamma(00000291)=0.127570346293885E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 291 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000291)=0.000000000000000E+00 beta (00000292)=0.130386455198231E+02 gamma(00000292)=0.130386455198231E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 292 z1= 1 0.533801542053867E-04 0.000000000000000E+00 z1= 2 -.800454338490621E-02 0.000000000000000E+00 z1= 3 -.703355055541828E-04 0.000000000000000E+00 alpha(00000292)=0.000000000000000E+00 beta (00000293)=0.130397919008274E+02 gamma(00000293)=0.130397919008274E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 293 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000293)=0.000000000000000E+00 beta (00000294)=0.134245685252204E+02 gamma(00000294)=0.134245685252204E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 294 z1= 1 -.646375498139186E-04 0.000000000000000E+00 z1= 2 0.835133662574144E-02 0.000000000000000E+00 z1= 3 0.732690111926392E-04 0.000000000000000E+00 alpha(00000294)=0.000000000000000E+00 beta (00000295)=0.123567774775316E+02 gamma(00000295)=0.123567774775316E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 295 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000295)=0.000000000000000E+00 beta (00000296)=0.136459622042417E+02 gamma(00000296)=0.136459622042417E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 296 z1= 1 0.585486787332305E-04 0.000000000000000E+00 z1= 2 -.822810745651238E-02 0.000000000000000E+00 z1= 3 -.658307339254178E-04 0.000000000000000E+00 alpha(00000296)=0.000000000000000E+00 beta (00000297)=0.124630775878943E+02 gamma(00000297)=0.124630775878943E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 297 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000297)=0.000000000000000E+00 beta (00000298)=0.133267951277081E+02 gamma(00000298)=0.133267951277081E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 298 z1= 1 -.644920855562975E-04 0.000000000000000E+00 z1= 2 0.845924583735208E-02 0.000000000000000E+00 z1= 3 0.644148467173739E-04 0.000000000000000E+00 alpha(00000298)=0.000000000000000E+00 beta (00000299)=0.125349436809378E+02 gamma(00000299)=0.125349436809378E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 299 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000299)=0.000000000000000E+00 beta (00000300)=0.131101814271766E+02 gamma(00000300)=0.131101814271766E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 300 z1= 1 0.717180739185511E-04 0.000000000000000E+00 z1= 2 -.877899543438109E-02 0.000000000000000E+00 z1= 3 -.716477071342523E-04 0.000000000000000E+00 alpha(00000300)=0.000000000000000E+00 beta (00000301)=0.122929659285492E+02 gamma(00000301)=0.122929659285492E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 301 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000301)=0.000000000000000E+00 beta (00000302)=0.128678348821517E+02 gamma(00000302)=0.128678348821517E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 302 z1= 1 -.760185253041237E-04 0.000000000000000E+00 z1= 2 0.901842537358732E-02 0.000000000000000E+00 z1= 3 0.727924887853299E-04 0.000000000000000E+00 alpha(00000302)=0.000000000000000E+00 beta (00000303)=0.128431052609254E+02 gamma(00000303)=0.128431052609254E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 303 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000303)=0.000000000000000E+00 beta (00000304)=0.134648021264901E+02 gamma(00000304)=0.134648021264901E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 304 z1= 1 0.816557265644730E-04 0.000000000000000E+00 z1= 2 -.923029879720956E-02 0.000000000000000E+00 z1= 3 -.786201488944702E-04 0.000000000000000E+00 alpha(00000304)=0.000000000000000E+00 beta (00000305)=0.129101591145707E+02 gamma(00000305)=0.129101591145707E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 305 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000305)=0.000000000000000E+00 beta (00000306)=0.134088717563700E+02 gamma(00000306)=0.134088717563700E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 306 z1= 1 -.799107549575417E-04 0.000000000000000E+00 z1= 2 0.957396405535372E-02 0.000000000000000E+00 z1= 3 0.753867151543803E-04 0.000000000000000E+00 alpha(00000306)=0.000000000000000E+00 beta (00000307)=0.123365793855968E+02 gamma(00000307)=0.123365793855968E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 307 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000307)=0.000000000000000E+00 beta (00000308)=0.134924336615679E+02 gamma(00000308)=0.134924336615679E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 308 z1= 1 0.843723711962691E-04 0.000000000000000E+00 z1= 2 -.929755501692319E-02 0.000000000000000E+00 z1= 3 -.781185773789325E-04 0.000000000000000E+00 alpha(00000308)=0.000000000000000E+00 beta (00000309)=0.124605533390144E+02 gamma(00000309)=0.124605533390144E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 309 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000309)=0.000000000000000E+00 beta (00000310)=0.130632789671551E+02 gamma(00000310)=0.130632789671551E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 310 z1= 1 -.848494602917970E-04 0.000000000000000E+00 z1= 2 0.947086608863019E-02 0.000000000000000E+00 z1= 3 0.800639893711091E-04 0.000000000000000E+00 alpha(00000310)=0.000000000000000E+00 beta (00000311)=0.128413885850914E+02 gamma(00000311)=0.128413885850914E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 311 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000311)=0.000000000000000E+00 beta (00000312)=0.133508491166860E+02 gamma(00000312)=0.133508491166860E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 312 z1= 1 0.865028752754090E-04 0.000000000000000E+00 z1= 2 -.959372864665689E-02 0.000000000000000E+00 z1= 3 -.825043806503081E-04 0.000000000000000E+00 alpha(00000312)=0.000000000000000E+00 beta (00000313)=0.123303428665723E+02 gamma(00000313)=0.123303428665723E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 313 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000313)=0.000000000000000E+00 beta (00000314)=0.126418284869245E+02 gamma(00000314)=0.126418284869245E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 314 z1= 1 -.876644476443880E-04 0.000000000000000E+00 z1= 2 0.949147272078723E-02 0.000000000000000E+00 z1= 3 0.860321541939387E-04 0.000000000000000E+00 alpha(00000314)=0.000000000000000E+00 beta (00000315)=0.123961306134985E+02 gamma(00000315)=0.123961306134985E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 315 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000315)=0.000000000000000E+00 beta (00000316)=0.129729601237860E+02 gamma(00000316)=0.129729601237860E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 316 z1= 1 0.906239091007922E-04 0.000000000000000E+00 z1= 2 -.879874085531584E-02 0.000000000000000E+00 z1= 3 -.847452444014027E-04 0.000000000000000E+00 alpha(00000316)=0.000000000000000E+00 beta (00000317)=0.128860328051688E+02 gamma(00000317)=0.128860328051688E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 317 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000317)=0.000000000000000E+00 beta (00000318)=0.135230187083878E+02 gamma(00000318)=0.135230187083878E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 318 z1= 1 -.908827507608402E-04 0.000000000000000E+00 z1= 2 0.813905622087086E-02 0.000000000000000E+00 z1= 3 0.837321950741308E-04 0.000000000000000E+00 alpha(00000318)=0.000000000000000E+00 beta (00000319)=0.129201240939568E+02 gamma(00000319)=0.129201240939568E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 319 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000319)=0.000000000000000E+00 beta (00000320)=0.131240507492423E+02 gamma(00000320)=0.131240507492423E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 320 z1= 1 0.922629866150861E-04 0.000000000000000E+00 z1= 2 -.807875585182301E-02 0.000000000000000E+00 z1= 3 -.825904388663764E-04 0.000000000000000E+00 alpha(00000320)=0.000000000000000E+00 beta (00000321)=0.121816953821806E+02 gamma(00000321)=0.121816953821806E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 321 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000321)=0.000000000000000E+00 beta (00000322)=0.131501281143647E+02 gamma(00000322)=0.131501281143647E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 322 z1= 1 -.882341433815249E-04 0.000000000000000E+00 z1= 2 0.770462376531990E-02 0.000000000000000E+00 z1= 3 0.801083073616374E-04 0.000000000000000E+00 alpha(00000322)=0.000000000000000E+00 beta (00000323)=0.129352335566502E+02 gamma(00000323)=0.129352335566502E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 323 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000323)=0.000000000000000E+00 beta (00000324)=0.134023876033624E+02 gamma(00000324)=0.134023876033624E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 324 z1= 1 0.907652585526084E-04 0.000000000000000E+00 z1= 2 -.769457420249243E-02 0.000000000000000E+00 z1= 3 -.750646815021648E-04 0.000000000000000E+00 alpha(00000324)=0.000000000000000E+00 beta (00000325)=0.124313950667097E+02 gamma(00000325)=0.124313950667097E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 325 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000325)=0.000000000000000E+00 beta (00000326)=0.137477820824771E+02 gamma(00000326)=0.137477820824771E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 326 z1= 1 -.874291295977663E-04 0.000000000000000E+00 z1= 2 0.744724956885943E-02 0.000000000000000E+00 z1= 3 0.745131434348452E-04 0.000000000000000E+00 alpha(00000326)=0.000000000000000E+00 beta (00000327)=0.125946989507707E+02 gamma(00000327)=0.125946989507707E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 327 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000327)=0.000000000000000E+00 beta (00000328)=0.134385468392722E+02 gamma(00000328)=0.134385468392722E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 328 z1= 1 0.908759738345152E-04 0.000000000000000E+00 z1= 2 -.765500698875007E-02 0.000000000000000E+00 z1= 3 -.694016994545449E-04 0.000000000000000E+00 alpha(00000328)=0.000000000000000E+00 beta (00000329)=0.123274838686290E+02 gamma(00000329)=0.123274838686290E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 329 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000329)=0.000000000000000E+00 beta (00000330)=0.134403961038268E+02 gamma(00000330)=0.134403961038268E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 330 z1= 1 -.887472362054156E-04 0.000000000000000E+00 z1= 2 0.767352609594868E-02 0.000000000000000E+00 z1= 3 0.748849754846626E-04 0.000000000000000E+00 alpha(00000330)=0.000000000000000E+00 beta (00000331)=0.127481528169622E+02 gamma(00000331)=0.127481528169622E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 331 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000331)=0.000000000000000E+00 beta (00000332)=0.134865061876686E+02 gamma(00000332)=0.134865061876686E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 332 z1= 1 0.100435413616820E-03 0.000000000000000E+00 z1= 2 -.789884067605638E-02 0.000000000000000E+00 z1= 3 -.784920337842534E-04 0.000000000000000E+00 alpha(00000332)=0.000000000000000E+00 beta (00000333)=0.123501319412180E+02 gamma(00000333)=0.123501319412180E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 333 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000333)=0.000000000000000E+00 beta (00000334)=0.131105484556980E+02 gamma(00000334)=0.131105484556980E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 334 z1= 1 -.104577580210142E-03 0.000000000000000E+00 z1= 2 0.768215026576914E-02 0.000000000000000E+00 z1= 3 0.822830048468930E-04 0.000000000000000E+00 alpha(00000334)=0.000000000000000E+00 beta (00000335)=0.126402958370504E+02 gamma(00000335)=0.126402958370504E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 335 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000335)=0.000000000000000E+00 beta (00000336)=0.129348040246015E+02 gamma(00000336)=0.129348040246015E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 336 z1= 1 0.124277864528136E-03 0.000000000000000E+00 z1= 2 -.728848032321339E-02 0.000000000000000E+00 z1= 3 -.935579047993527E-04 0.000000000000000E+00 alpha(00000336)=0.000000000000000E+00 beta (00000337)=0.122648534010143E+02 gamma(00000337)=0.122648534010143E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 337 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000337)=0.000000000000000E+00 beta (00000338)=0.128879754967854E+02 gamma(00000338)=0.128879754967854E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 338 z1= 1 -.126837708523592E-03 0.000000000000000E+00 z1= 2 0.652313927187844E-02 0.000000000000000E+00 z1= 3 0.977485846030512E-04 0.000000000000000E+00 alpha(00000338)=0.000000000000000E+00 beta (00000339)=0.123601633942249E+02 gamma(00000339)=0.123601633942249E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 339 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000339)=0.000000000000000E+00 beta (00000340)=0.133847546928195E+02 gamma(00000340)=0.133847546928195E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 340 z1= 1 0.137603726928292E-03 0.000000000000000E+00 z1= 2 -.560988415764112E-02 0.000000000000000E+00 z1= 3 -.107608622350133E-03 0.000000000000000E+00 alpha(00000340)=0.000000000000000E+00 beta (00000341)=0.124138829481768E+02 gamma(00000341)=0.124138829481768E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 341 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000341)=0.000000000000000E+00 beta (00000342)=0.134003497088344E+02 gamma(00000342)=0.134003497088344E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 342 z1= 1 -.132880252442520E-03 0.000000000000000E+00 z1= 2 0.481915307387459E-02 0.000000000000000E+00 z1= 3 0.107185130359848E-03 0.000000000000000E+00 alpha(00000342)=0.000000000000000E+00 beta (00000343)=0.128688430293115E+02 gamma(00000343)=0.128688430293115E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 343 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000343)=0.000000000000000E+00 beta (00000344)=0.131638701802712E+02 gamma(00000344)=0.131638701802712E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 344 z1= 1 0.156188690862992E-03 0.000000000000000E+00 z1= 2 -.433505944963169E-02 0.000000000000000E+00 z1= 3 -.124426487309313E-03 0.000000000000000E+00 alpha(00000344)=0.000000000000000E+00 beta (00000345)=0.120790597184999E+02 gamma(00000345)=0.120790597184999E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 345 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000345)=0.000000000000000E+00 beta (00000346)=0.129347855267666E+02 gamma(00000346)=0.129347855267666E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 346 z1= 1 -.143549385189373E-03 0.000000000000000E+00 z1= 2 0.382028239813775E-02 0.000000000000000E+00 z1= 3 0.117897535179168E-03 0.000000000000000E+00 alpha(00000346)=0.000000000000000E+00 beta (00000347)=0.129717929308421E+02 gamma(00000347)=0.129717929308421E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 347 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000347)=0.000000000000000E+00 beta (00000348)=0.136997542058981E+02 gamma(00000348)=0.136997542058981E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 348 z1= 1 0.159729749446294E-03 0.000000000000000E+00 z1= 2 -.368643740608795E-02 0.000000000000000E+00 z1= 3 -.129366282508570E-03 0.000000000000000E+00 alpha(00000348)=0.000000000000000E+00 beta (00000349)=0.126861143721747E+02 gamma(00000349)=0.126861143721747E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 349 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000349)=0.000000000000000E+00 beta (00000350)=0.130565940889256E+02 gamma(00000350)=0.130565940889256E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 350 z1= 1 -.147698402150765E-03 0.000000000000000E+00 z1= 2 0.369759440568428E-02 0.000000000000000E+00 z1= 3 0.125143137766442E-03 0.000000000000000E+00 alpha(00000350)=0.000000000000000E+00 beta (00000351)=0.124777320428023E+02 gamma(00000351)=0.124777320428023E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 351 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000351)=0.000000000000000E+00 beta (00000352)=0.135382839128267E+02 gamma(00000352)=0.135382839128267E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 352 z1= 1 0.153323501460793E-03 0.000000000000000E+00 z1= 2 -.359799746694780E-02 0.000000000000000E+00 z1= 3 -.134971027995852E-03 0.000000000000000E+00 alpha(00000352)=0.000000000000000E+00 beta (00000353)=0.127403836115985E+02 gamma(00000353)=0.127403836115985E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 353 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000353)=0.000000000000000E+00 beta (00000354)=0.134598637181962E+02 gamma(00000354)=0.134598637181962E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 354 z1= 1 -.135132079115259E-03 0.000000000000000E+00 z1= 2 0.377969538921282E-02 0.000000000000000E+00 z1= 3 0.127122362051755E-03 0.000000000000000E+00 alpha(00000354)=0.000000000000000E+00 beta (00000355)=0.127281385974926E+02 gamma(00000355)=0.127281385974926E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 355 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000355)=0.000000000000000E+00 beta (00000356)=0.135676735412423E+02 gamma(00000356)=0.135676735412423E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 356 z1= 1 0.140292107199805E-03 0.000000000000000E+00 z1= 2 -.385765616940412E-02 0.000000000000000E+00 z1= 3 -.135562754722631E-03 0.000000000000000E+00 alpha(00000356)=0.000000000000000E+00 beta (00000357)=0.126308157793315E+02 gamma(00000357)=0.126308157793315E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 357 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000357)=0.000000000000000E+00 beta (00000358)=0.130551304137372E+02 gamma(00000358)=0.130551304137372E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 358 z1= 1 -.130702852078821E-03 0.000000000000000E+00 z1= 2 0.402209283931543E-02 0.000000000000000E+00 z1= 3 0.134445470474623E-03 0.000000000000000E+00 alpha(00000358)=0.000000000000000E+00 beta (00000359)=0.125384776424810E+02 gamma(00000359)=0.125384776424810E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 359 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000359)=0.000000000000000E+00 beta (00000360)=0.138671431545344E+02 gamma(00000360)=0.138671431545344E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 360 z1= 1 0.117521509820988E-03 0.000000000000000E+00 z1= 2 -.387894229675864E-02 0.000000000000000E+00 z1= 3 -.130752976770228E-03 0.000000000000000E+00 alpha(00000360)=0.000000000000000E+00 beta (00000361)=0.124807384942565E+02 gamma(00000361)=0.124807384942565E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 361 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000361)=0.000000000000000E+00 beta (00000362)=0.128336700954557E+02 gamma(00000362)=0.128336700954557E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 362 z1= 1 -.120216903323780E-03 0.000000000000000E+00 z1= 2 0.380946788733819E-02 0.000000000000000E+00 z1= 3 0.139927510384358E-03 0.000000000000000E+00 alpha(00000362)=0.000000000000000E+00 beta (00000363)=0.120980702094815E+02 gamma(00000363)=0.120980702094815E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 363 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000363)=0.000000000000000E+00 beta (00000364)=0.134861476620713E+02 gamma(00000364)=0.134861476620713E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 364 z1= 1 0.104183068834270E-03 0.000000000000000E+00 z1= 2 -.310239131403137E-02 0.000000000000000E+00 z1= 3 -.130377701006396E-03 0.000000000000000E+00 alpha(00000364)=0.000000000000000E+00 beta (00000365)=0.125592246919909E+02 gamma(00000365)=0.125592246919909E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 365 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000365)=0.000000000000000E+00 beta (00000366)=0.133171542754747E+02 gamma(00000366)=0.133171542754747E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 366 z1= 1 -.117459874657476E-03 0.000000000000000E+00 z1= 2 0.264682775487341E-02 0.000000000000000E+00 z1= 3 0.145230664256834E-03 0.000000000000000E+00 alpha(00000366)=0.000000000000000E+00 beta (00000367)=0.127384803788412E+02 gamma(00000367)=0.127384803788412E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 367 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000367)=0.000000000000000E+00 beta (00000368)=0.128735594660904E+02 gamma(00000368)=0.128735594660904E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 368 z1= 1 0.107457205382342E-03 0.000000000000000E+00 z1= 2 -.264249054949825E-02 0.000000000000000E+00 z1= 3 -.146877907334131E-03 0.000000000000000E+00 alpha(00000368)=0.000000000000000E+00 beta (00000369)=0.123686208425099E+02 gamma(00000369)=0.123686208425099E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 369 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000369)=0.000000000000000E+00 beta (00000370)=0.135761546627364E+02 gamma(00000370)=0.135761546627364E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 370 z1= 1 -.123405190724637E-03 0.000000000000000E+00 z1= 2 0.256811172419620E-02 0.000000000000000E+00 z1= 3 0.163041395105359E-03 0.000000000000000E+00 alpha(00000370)=0.000000000000000E+00 beta (00000371)=0.128573216410899E+02 gamma(00000371)=0.128573216410899E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 371 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000371)=0.000000000000000E+00 beta (00000372)=0.131048701557456E+02 gamma(00000372)=0.131048701557456E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 372 z1= 1 0.112448785315969E-03 0.000000000000000E+00 z1= 2 -.272898868143880E-02 0.000000000000000E+00 z1= 3 -.164318551244393E-03 0.000000000000000E+00 alpha(00000372)=0.000000000000000E+00 beta (00000373)=0.120225443850653E+02 gamma(00000373)=0.120225443850653E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 373 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000373)=0.000000000000000E+00 beta (00000374)=0.131418035969991E+02 gamma(00000374)=0.131418035969991E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 374 z1= 1 -.133902705916996E-03 0.000000000000000E+00 z1= 2 0.266309904812624E-02 0.000000000000000E+00 z1= 3 0.183161444510942E-03 0.000000000000000E+00 alpha(00000374)=0.000000000000000E+00 beta (00000375)=0.132587026146158E+02 gamma(00000375)=0.132587026146158E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 375 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000375)=0.000000000000000E+00 beta (00000376)=0.128757454224153E+02 gamma(00000376)=0.128757454224153E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 376 z1= 1 0.121675925452369E-03 0.000000000000000E+00 z1= 2 -.280409477833576E-02 0.000000000000000E+00 z1= 3 -.186544937110300E-03 0.000000000000000E+00 alpha(00000376)=0.000000000000000E+00 beta (00000377)=0.123390270026165E+02 gamma(00000377)=0.123390270026165E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 377 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000377)=0.000000000000000E+00 beta (00000378)=0.134179105413038E+02 gamma(00000378)=0.134179105413038E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 378 z1= 1 -.144101900840211E-03 0.000000000000000E+00 z1= 2 0.266501047526931E-02 0.000000000000000E+00 z1= 3 0.201917763135426E-03 0.000000000000000E+00 alpha(00000378)=0.000000000000000E+00 beta (00000379)=0.125818217045465E+02 gamma(00000379)=0.125818217045465E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 379 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000379)=0.000000000000000E+00 beta (00000380)=0.131272108262847E+02 gamma(00000380)=0.131272108262847E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 380 z1= 1 0.123839023546045E-03 0.000000000000000E+00 z1= 2 -.274285472103942E-02 0.000000000000000E+00 z1= 3 -.194362601801776E-03 0.000000000000000E+00 alpha(00000380)=0.000000000000000E+00 beta (00000381)=0.124970641056351E+02 gamma(00000381)=0.124970641056351E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 381 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000381)=0.000000000000000E+00 beta (00000382)=0.133547567282743E+02 gamma(00000382)=0.133547567282743E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 382 z1= 1 -.144475801027453E-03 0.000000000000000E+00 z1= 2 0.281445229120011E-02 0.000000000000000E+00 z1= 3 0.207271874709411E-03 0.000000000000000E+00 alpha(00000382)=0.000000000000000E+00 beta (00000383)=0.126670022404867E+02 gamma(00000383)=0.126670022404867E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 383 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000383)=0.000000000000000E+00 beta (00000384)=0.129178449424552E+02 gamma(00000384)=0.129178449424552E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 384 z1= 1 0.116269641407515E-03 0.000000000000000E+00 z1= 2 -.319283570690535E-02 0.000000000000000E+00 z1= 3 -.202003400307748E-03 0.000000000000000E+00 alpha(00000384)=0.000000000000000E+00 beta (00000385)=0.124532035195994E+02 gamma(00000385)=0.124532035195994E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 385 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000385)=0.000000000000000E+00 beta (00000386)=0.125978432002159E+02 gamma(00000386)=0.125978432002159E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 386 z1= 1 -.150251702033535E-03 0.000000000000000E+00 z1= 2 0.366551399839877E-02 0.000000000000000E+00 z1= 3 0.227502012557611E-03 0.000000000000000E+00 alpha(00000386)=0.000000000000000E+00 beta (00000387)=0.126749853508409E+02 gamma(00000387)=0.126749853508409E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 387 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000387)=0.000000000000000E+00 beta (00000388)=0.131986351646860E+02 gamma(00000388)=0.131986351646860E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 388 z1= 1 0.102746880488570E-03 0.000000000000000E+00 z1= 2 -.407482824266961E-02 0.000000000000000E+00 z1= 3 -.209535155789359E-03 0.000000000000000E+00 alpha(00000388)=0.000000000000000E+00 beta (00000389)=0.128142582016140E+02 gamma(00000389)=0.128142582016140E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 389 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000389)=0.000000000000000E+00 beta (00000390)=0.135326154946843E+02 gamma(00000390)=0.135326154946843E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 390 z1= 1 -.148744237611042E-03 0.000000000000000E+00 z1= 2 0.456812236643524E-02 0.000000000000000E+00 z1= 3 0.230306567037359E-03 0.000000000000000E+00 alpha(00000390)=0.000000000000000E+00 beta (00000391)=0.127721346913490E+02 gamma(00000391)=0.127721346913490E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 391 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000391)=0.000000000000000E+00 beta (00000392)=0.134207557748489E+02 gamma(00000392)=0.134207557748489E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 392 z1= 1 0.890143792641480E-04 0.000000000000000E+00 z1= 2 -.503967367795706E-02 0.000000000000000E+00 z1= 3 -.204721558460112E-03 0.000000000000000E+00 alpha(00000392)=0.000000000000000E+00 beta (00000393)=0.127273607787238E+02 gamma(00000393)=0.127273607787238E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 393 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000393)=0.000000000000000E+00 beta (00000394)=0.127710246973649E+02 gamma(00000394)=0.127710246973649E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 394 z1= 1 -.143414280529395E-03 0.000000000000000E+00 z1= 2 0.564809814471168E-02 0.000000000000000E+00 z1= 3 0.244097821796674E-03 0.000000000000000E+00 alpha(00000394)=0.000000000000000E+00 beta (00000395)=0.127731324494839E+02 gamma(00000395)=0.127731324494839E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 395 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000395)=0.000000000000000E+00 beta (00000396)=0.133820436990060E+02 gamma(00000396)=0.133820436990060E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 396 z1= 1 0.876233794431789E-04 0.000000000000000E+00 z1= 2 -.602758582274009E-02 0.000000000000000E+00 z1= 3 -.220941390847989E-03 0.000000000000000E+00 alpha(00000396)=0.000000000000000E+00 beta (00000397)=0.123991961121374E+02 gamma(00000397)=0.123991961121374E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 397 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000397)=0.000000000000000E+00 beta (00000398)=0.129222599692197E+02 gamma(00000398)=0.129222599692197E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 398 z1= 1 -.147818062393185E-03 0.000000000000000E+00 z1= 2 0.646995975113578E-02 0.000000000000000E+00 z1= 3 0.257184657384784E-03 0.000000000000000E+00 alpha(00000398)=0.000000000000000E+00 beta (00000399)=0.124209907543891E+02 gamma(00000399)=0.124209907543891E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 399 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000399)=0.000000000000000E+00 beta (00000400)=0.139549581286603E+02 gamma(00000400)=0.139549581286603E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 400 z1= 1 0.604414121882749E-04 0.000000000000000E+00 z1= 2 -.657475001733264E-02 0.000000000000000E+00 z1= 3 -.202380175967838E-03 0.000000000000000E+00 alpha(00000400)=0.000000000000000E+00 beta (00000401)=0.126202625779024E+02 gamma(00000401)=0.126202625779024E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 401 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000401)=0.000000000000000E+00 beta (00000402)=0.132778380122615E+02 gamma(00000402)=0.132778380122615E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 402 z1= 1 -.131755047439753E-03 0.000000000000000E+00 z1= 2 0.719301659513567E-02 0.000000000000000E+00 z1= 3 0.238652043907723E-03 0.000000000000000E+00 alpha(00000402)=0.000000000000000E+00 beta (00000403)=0.124752525494700E+02 gamma(00000403)=0.124752525494700E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 403 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000403)=0.000000000000000E+00 beta (00000404)=0.130874359276216E+02 gamma(00000404)=0.130874359276216E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 404 z1= 1 0.499399517099311E-04 0.000000000000000E+00 z1= 2 -.785309230590133E-02 0.000000000000000E+00 z1= 3 -.201784061623004E-03 0.000000000000000E+00 alpha(00000404)=0.000000000000000E+00 beta (00000405)=0.130442054752015E+02 gamma(00000405)=0.130442054752015E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 405 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000405)=0.000000000000000E+00 beta (00000406)=0.131863981475128E+02 gamma(00000406)=0.131863981475128E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 406 z1= 1 -.129912547579463E-03 0.000000000000000E+00 z1= 2 0.844704431108322E-02 0.000000000000000E+00 z1= 3 0.251702829857578E-03 0.000000000000000E+00 alpha(00000406)=0.000000000000000E+00 beta (00000407)=0.126585159945118E+02 gamma(00000407)=0.126585159945118E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 407 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000407)=0.000000000000000E+00 beta (00000408)=0.125986956518064E+02 gamma(00000408)=0.125986956518064E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 408 z1= 1 0.491117853295337E-04 0.000000000000000E+00 z1= 2 -.883541758516193E-02 0.000000000000000E+00 z1= 3 -.224462915486585E-03 0.000000000000000E+00 alpha(00000408)=0.000000000000000E+00 beta (00000409)=0.125370806010007E+02 gamma(00000409)=0.125370806010007E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 409 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000409)=0.000000000000000E+00 beta (00000410)=0.135647895183473E+02 gamma(00000410)=0.135647895183473E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 410 z1= 1 -.131815771676696E-03 0.000000000000000E+00 z1= 2 0.811507783545675E-02 0.000000000000000E+00 z1= 3 0.259621154184194E-03 0.000000000000000E+00 alpha(00000410)=0.000000000000000E+00 beta (00000411)=0.124944323367107E+02 gamma(00000411)=0.124944323367107E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 411 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000411)=0.000000000000000E+00 beta (00000412)=0.134174361470668E+02 gamma(00000412)=0.134174361470668E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 412 z1= 1 0.238908905414131E-04 0.000000000000000E+00 z1= 2 -.724870965293474E-02 0.000000000000000E+00 z1= 3 -.196882274720235E-03 0.000000000000000E+00 alpha(00000412)=0.000000000000000E+00 beta (00000413)=0.128380914139328E+02 gamma(00000413)=0.128380914139328E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 413 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000413)=0.000000000000000E+00 beta (00000414)=0.132554291171298E+02 gamma(00000414)=0.132554291171298E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 414 z1= 1 -.124072604088765E-03 0.000000000000000E+00 z1= 2 0.658850724356112E-02 0.000000000000000E+00 z1= 3 0.251675719519943E-03 0.000000000000000E+00 alpha(00000414)=0.000000000000000E+00 beta (00000415)=0.126883860098849E+02 gamma(00000415)=0.126883860098849E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 415 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000415)=0.000000000000000E+00 beta (00000416)=0.137441954691421E+02 gamma(00000416)=0.137441954691421E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 416 z1= 1 0.154542051731786E-04 0.000000000000000E+00 z1= 2 -.592660167726020E-02 0.000000000000000E+00 z1= 3 -.190346910282245E-03 0.000000000000000E+00 alpha(00000416)=0.000000000000000E+00 beta (00000417)=0.126367412161439E+02 gamma(00000417)=0.126367412161439E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 417 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000417)=0.000000000000000E+00 beta (00000418)=0.124572188702229E+02 gamma(00000418)=0.124572188702229E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 418 z1= 1 -.864988083723681E-04 0.000000000000000E+00 z1= 2 0.621216811626484E-02 0.000000000000000E+00 z1= 3 0.242000322921940E-03 0.000000000000000E+00 alpha(00000418)=0.000000000000000E+00 beta (00000419)=0.128604064983239E+02 gamma(00000419)=0.128604064983239E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 419 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000419)=0.000000000000000E+00 beta (00000420)=0.135324441284191E+02 gamma(00000420)=0.135324441284191E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 420 z1= 1 0.632163896797022E-05 0.000000000000000E+00 z1= 2 -.628996011586065E-02 0.000000000000000E+00 z1= 3 -.198464861552473E-03 0.000000000000000E+00 alpha(00000420)=0.000000000000000E+00 beta (00000421)=0.126928826103743E+02 gamma(00000421)=0.126928826103743E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 421 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000421)=0.000000000000000E+00 beta (00000422)=0.132376408921131E+02 gamma(00000422)=0.132376408921131E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 422 z1= 1 -.487677821705492E-04 0.000000000000000E+00 z1= 2 0.677281243929254E-02 0.000000000000000E+00 z1= 3 0.218424893799484E-03 0.000000000000000E+00 alpha(00000422)=0.000000000000000E+00 beta (00000423)=0.124808474172186E+02 gamma(00000423)=0.124808474172186E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 423 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000423)=0.000000000000000E+00 beta (00000424)=0.131642708375109E+02 gamma(00000424)=0.131642708375109E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 424 z1= 1 -.377909915876256E-05 0.000000000000000E+00 z1= 2 -.748365035004757E-02 0.000000000000000E+00 z1= 3 -.191132645110047E-03 0.000000000000000E+00 alpha(00000424)=0.000000000000000E+00 beta (00000425)=0.123773527005399E+02 gamma(00000425)=0.123773527005399E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 425 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000425)=0.000000000000000E+00 beta (00000426)=0.131119815230535E+02 gamma(00000426)=0.131119815230535E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 426 z1= 1 0.826367539682972E-05 0.000000000000000E+00 z1= 2 0.790105529462597E-02 0.000000000000000E+00 z1= 3 0.189029138961777E-03 0.000000000000000E+00 alpha(00000426)=0.000000000000000E+00 beta (00000427)=0.120875372383283E+02 gamma(00000427)=0.120875372383283E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 427 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000427)=0.000000000000000E+00 beta (00000428)=0.130246565801478E+02 gamma(00000428)=0.130246565801478E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 428 z1= 1 -.303406719067954E-04 0.000000000000000E+00 z1= 2 -.774668462127607E-02 0.000000000000000E+00 z1= 3 -.184832905623072E-03 0.000000000000000E+00 alpha(00000428)=0.000000000000000E+00 beta (00000429)=0.128541117350673E+02 gamma(00000429)=0.128541117350673E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 429 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000429)=0.000000000000000E+00 beta (00000430)=0.130604411720440E+02 gamma(00000430)=0.130604411720440E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 430 z1= 1 0.655221966201025E-04 0.000000000000000E+00 z1= 2 0.764053126607364E-02 0.000000000000000E+00 z1= 3 0.164756897143300E-03 0.000000000000000E+00 alpha(00000430)=0.000000000000000E+00 beta (00000431)=0.123533753982134E+02 gamma(00000431)=0.123533753982134E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 431 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000431)=0.000000000000000E+00 beta (00000432)=0.129313045437982E+02 gamma(00000432)=0.129313045437982E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 432 z1= 1 -.538667269633827E-04 0.000000000000000E+00 z1= 2 -.687251504678888E-02 0.000000000000000E+00 z1= 3 -.187637043082108E-03 0.000000000000000E+00 alpha(00000432)=0.000000000000000E+00 beta (00000433)=0.121311420270794E+02 gamma(00000433)=0.121311420270794E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 433 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000433)=0.000000000000000E+00 beta (00000434)=0.134525838152849E+02 gamma(00000434)=0.134525838152849E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 434 z1= 1 0.121598184337700E-03 0.000000000000000E+00 z1= 2 0.582082327841891E-02 0.000000000000000E+00 z1= 3 0.124630116197153E-03 0.000000000000000E+00 alpha(00000434)=0.000000000000000E+00 beta (00000435)=0.133048923237988E+02 gamma(00000435)=0.133048923237988E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 435 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000435)=0.000000000000000E+00 beta (00000436)=0.131665853825577E+02 gamma(00000436)=0.131665853825577E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 436 z1= 1 -.772454593546555E-04 0.000000000000000E+00 z1= 2 -.580847659505435E-02 0.000000000000000E+00 z1= 3 -.192962374123779E-03 0.000000000000000E+00 alpha(00000436)=0.000000000000000E+00 beta (00000437)=0.125574321164418E+02 gamma(00000437)=0.125574321164418E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 437 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000437)=0.000000000000000E+00 beta (00000438)=0.131909615849617E+02 gamma(00000438)=0.131909615849617E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 438 z1= 1 0.177262018259229E-03 0.000000000000000E+00 z1= 2 0.563429974991760E-02 0.000000000000000E+00 z1= 3 0.114911668533101E-03 0.000000000000000E+00 alpha(00000438)=0.000000000000000E+00 beta (00000439)=0.124668675933479E+02 gamma(00000439)=0.124668675933479E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 439 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000439)=0.000000000000000E+00 beta (00000440)=0.125548784571794E+02 gamma(00000440)=0.125548784571794E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 440 z1= 1 -.947588121590487E-04 0.000000000000000E+00 z1= 2 -.561496231878730E-02 0.000000000000000E+00 z1= 3 -.206100832528038E-03 0.000000000000000E+00 alpha(00000440)=0.000000000000000E+00 beta (00000441)=0.127926285713272E+02 gamma(00000441)=0.127926285713272E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 441 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000441)=0.000000000000000E+00 beta (00000442)=0.131376092823159E+02 gamma(00000442)=0.131376092823159E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 442 z1= 1 0.234011892003725E-03 0.000000000000000E+00 z1= 2 0.532222617026528E-02 0.000000000000000E+00 z1= 3 0.105844047461242E-03 0.000000000000000E+00 alpha(00000442)=0.000000000000000E+00 beta (00000443)=0.129406708106059E+02 gamma(00000443)=0.129406708106059E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 443 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000443)=0.000000000000000E+00 beta (00000444)=0.135492582525097E+02 gamma(00000444)=0.135492582525097E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 444 z1= 1 -.939702744134937E-04 0.000000000000000E+00 z1= 2 -.523579668704349E-02 0.000000000000000E+00 z1= 3 -.220867968695254E-03 0.000000000000000E+00 alpha(00000444)=0.000000000000000E+00 beta (00000445)=0.128146352399074E+02 gamma(00000445)=0.128146352399074E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 445 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000445)=0.000000000000000E+00 beta (00000446)=0.136371439440830E+02 gamma(00000446)=0.136371439440830E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 446 z1= 1 0.262078515484221E-03 0.000000000000000E+00 z1= 2 0.539343703156364E-02 0.000000000000000E+00 z1= 3 0.928972213621508E-04 0.000000000000000E+00 alpha(00000446)=0.000000000000000E+00 beta (00000447)=0.125970531760047E+02 gamma(00000447)=0.125970531760047E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 447 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000447)=0.000000000000000E+00 beta (00000448)=0.131755824785178E+02 gamma(00000448)=0.131755824785178E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 448 z1= 1 -.149049820359624E-03 0.000000000000000E+00 z1= 2 -.573045006052961E-02 0.000000000000000E+00 z1= 3 -.190165760691259E-03 0.000000000000000E+00 alpha(00000448)=0.000000000000000E+00 beta (00000449)=0.125911044065738E+02 gamma(00000449)=0.125911044065738E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 449 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000449)=0.000000000000000E+00 beta (00000450)=0.133750911449696E+02 gamma(00000450)=0.133750911449696E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 450 z1= 1 0.279259052176004E-03 0.000000000000000E+00 z1= 2 0.566150485896926E-02 0.000000000000000E+00 z1= 3 0.956874017721049E-04 0.000000000000000E+00 alpha(00000450)=0.000000000000000E+00 beta (00000451)=0.126359620716266E+02 gamma(00000451)=0.126359620716266E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 451 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000451)=0.000000000000000E+00 beta (00000452)=0.137718130700751E+02 gamma(00000452)=0.137718130700751E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 452 z1= 1 -.207487812049663E-03 0.000000000000000E+00 z1= 2 -.512417606873902E-02 0.000000000000000E+00 z1= 3 -.142262938522453E-03 0.000000000000000E+00 alpha(00000452)=0.000000000000000E+00 beta (00000453)=0.119415870414081E+02 gamma(00000453)=0.119415870414081E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 453 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000453)=0.000000000000000E+00 beta (00000454)=0.131894659207979E+02 gamma(00000454)=0.131894659207979E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 454 z1= 1 0.274577265740449E-03 0.000000000000000E+00 z1= 2 0.436159071659360E-02 0.000000000000000E+00 z1= 3 0.894893167561246E-04 0.000000000000000E+00 alpha(00000454)=0.000000000000000E+00 beta (00000455)=0.122695813709360E+02 gamma(00000455)=0.122695813709360E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 455 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000455)=0.000000000000000E+00 beta (00000456)=0.130893711492243E+02 gamma(00000456)=0.130893711492243E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 456 z1= 1 -.276018864358470E-03 0.000000000000000E+00 z1= 2 -.349429816918950E-02 0.000000000000000E+00 z1= 3 -.854573497228374E-04 0.000000000000000E+00 alpha(00000456)=0.000000000000000E+00 beta (00000457)=0.123756699879025E+02 gamma(00000457)=0.123756699879025E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 457 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000457)=0.000000000000000E+00 beta (00000458)=0.132371830345480E+02 gamma(00000458)=0.132371830345480E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 458 z1= 1 0.302531654446406E-03 0.000000000000000E+00 z1= 2 0.294160650143627E-02 0.000000000000000E+00 z1= 3 0.894256297525141E-04 0.000000000000000E+00 alpha(00000458)=0.000000000000000E+00 beta (00000459)=0.127975516176493E+02 gamma(00000459)=0.127975516176493E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 459 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000459)=0.000000000000000E+00 beta (00000460)=0.131469452072187E+02 gamma(00000460)=0.131469452072187E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 460 z1= 1 -.350973310230069E-03 0.000000000000000E+00 z1= 2 -.284358355755971E-02 0.000000000000000E+00 z1= 3 -.426208244490685E-04 0.000000000000000E+00 alpha(00000460)=0.000000000000000E+00 beta (00000461)=0.129386258093384E+02 gamma(00000461)=0.129386258093384E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 461 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000461)=0.000000000000000E+00 beta (00000462)=0.127922552965345E+02 gamma(00000462)=0.127922552965345E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 462 z1= 1 0.365642972872423E-03 0.000000000000000E+00 z1= 2 0.324315893502457E-02 0.000000000000000E+00 z1= 3 0.920343515373881E-04 0.000000000000000E+00 alpha(00000462)=0.000000000000000E+00 beta (00000463)=0.127051048185439E+02 gamma(00000463)=0.127051048185439E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 463 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000463)=0.000000000000000E+00 beta (00000464)=0.136741741808404E+02 gamma(00000464)=0.136741741808404E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 464 z1= 1 -.413871804345322E-03 0.000000000000000E+00 z1= 2 -.351470709205646E-02 0.000000000000000E+00 z1= 3 -.110392213371280E-04 0.000000000000000E+00 alpha(00000464)=0.000000000000000E+00 beta (00000465)=0.124257845863767E+02 gamma(00000465)=0.124257845863767E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 465 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000465)=0.000000000000000E+00 beta (00000466)=0.130476047997520E+02 gamma(00000466)=0.130476047997520E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 466 z1= 1 0.386366259556289E-03 0.000000000000000E+00 z1= 2 0.376598462237834E-02 0.000000000000000E+00 z1= 3 0.886243566004455E-04 0.000000000000000E+00 alpha(00000466)=0.000000000000000E+00 beta (00000467)=0.128126795618825E+02 gamma(00000467)=0.128126795618825E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 467 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000467)=0.000000000000000E+00 beta (00000468)=0.132749533902331E+02 gamma(00000468)=0.132749533902331E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 468 z1= 1 -.469861291010547E-03 0.000000000000000E+00 z1= 2 -.358041284979337E-02 0.000000000000000E+00 z1= 3 0.113609335330312E-04 0.000000000000000E+00 alpha(00000468)=0.000000000000000E+00 beta (00000469)=0.130097888224366E+02 gamma(00000469)=0.130097888224366E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 469 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000469)=0.000000000000000E+00 beta (00000470)=0.130215464641228E+02 gamma(00000470)=0.130215464641228E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 470 z1= 1 0.442148024880537E-03 0.000000000000000E+00 z1= 2 0.317252986660435E-02 0.000000000000000E+00 z1= 3 0.840442628133298E-04 0.000000000000000E+00 alpha(00000470)=0.000000000000000E+00 beta (00000471)=0.126925122138114E+02 gamma(00000471)=0.126925122138114E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 471 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000471)=0.000000000000000E+00 beta (00000472)=0.131625945922498E+02 gamma(00000472)=0.131625945922498E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 472 z1= 1 -.527259592823205E-03 0.000000000000000E+00 z1= 2 -.294506816309703E-02 0.000000000000000E+00 z1= 3 0.196767121877336E-04 0.000000000000000E+00 alpha(00000472)=0.000000000000000E+00 beta (00000473)=0.127702464084218E+02 gamma(00000473)=0.127702464084218E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 473 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000473)=0.000000000000000E+00 beta (00000474)=0.136357607604215E+02 gamma(00000474)=0.136357607604215E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 474 z1= 1 0.468691558967332E-03 0.000000000000000E+00 z1= 2 0.305174767326616E-02 0.000000000000000E+00 z1= 3 0.661008178243730E-04 0.000000000000000E+00 alpha(00000474)=0.000000000000000E+00 beta (00000475)=0.128656769552773E+02 gamma(00000475)=0.128656769552773E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 475 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000475)=0.000000000000000E+00 beta (00000476)=0.131370538074366E+02 gamma(00000476)=0.131370538074366E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 476 z1= 1 -.552141097387640E-03 0.000000000000000E+00 z1= 2 -.338504137496424E-02 0.000000000000000E+00 z1= 3 0.146644350718522E-04 0.000000000000000E+00 alpha(00000476)=0.000000000000000E+00 beta (00000477)=0.126651212916985E+02 gamma(00000477)=0.126651212916985E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 477 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000477)=0.000000000000000E+00 beta (00000478)=0.130011815493291E+02 gamma(00000478)=0.130011815493291E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 478 z1= 1 0.533633845502928E-03 0.000000000000000E+00 z1= 2 0.353330310716759E-02 0.000000000000000E+00 z1= 3 0.357255338187320E-04 0.000000000000000E+00 alpha(00000478)=0.000000000000000E+00 beta (00000479)=0.127342578622939E+02 gamma(00000479)=0.127342578622939E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 479 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000479)=0.000000000000000E+00 beta (00000480)=0.129112072390009E+02 gamma(00000480)=0.129112072390009E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 480 z1= 1 -.609438140399130E-03 0.000000000000000E+00 z1= 2 -.360880510985911E-02 0.000000000000000E+00 z1= 3 0.119808666242634E-04 0.000000000000000E+00 alpha(00000480)=0.000000000000000E+00 beta (00000481)=0.127105148552206E+02 gamma(00000481)=0.127105148552206E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 481 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000481)=0.000000000000000E+00 beta (00000482)=0.126045678832189E+02 gamma(00000482)=0.126045678832189E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 482 z1= 1 0.619581316794672E-03 0.000000000000000E+00 z1= 2 0.394027859016295E-02 0.000000000000000E+00 z1= 3 0.296861833990478E-05 0.000000000000000E+00 alpha(00000482)=0.000000000000000E+00 beta (00000483)=0.130806293865671E+02 gamma(00000483)=0.130806293865671E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 483 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000483)=0.000000000000000E+00 beta (00000484)=0.132785557578354E+02 gamma(00000484)=0.132785557578354E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 484 z1= 1 -.689003238379817E-03 0.000000000000000E+00 z1= 2 -.422654052481431E-02 0.000000000000000E+00 z1= 3 0.155768825058500E-04 0.000000000000000E+00 alpha(00000484)=0.000000000000000E+00 beta (00000485)=0.118811861850065E+02 gamma(00000485)=0.118811861850065E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 485 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000485)=0.000000000000000E+00 beta (00000486)=0.136917132526631E+02 gamma(00000486)=0.136917132526631E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 486 z1= 1 0.602954015989839E-03 0.000000000000000E+00 z1= 2 0.396913478660904E-02 0.000000000000000E+00 z1= 3 -.223941722078434E-04 0.000000000000000E+00 alpha(00000486)=0.000000000000000E+00 beta (00000487)=0.122988133557640E+02 gamma(00000487)=0.122988133557640E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 487 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000487)=0.000000000000000E+00 beta (00000488)=0.135932793705360E+02 gamma(00000488)=0.135932793705360E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 488 z1= 1 -.638275089109331E-03 0.000000000000000E+00 z1= 2 -.335625341027109E-02 0.000000000000000E+00 z1= 3 0.290742540096596E-04 0.000000000000000E+00 alpha(00000488)=0.000000000000000E+00 beta (00000489)=0.123919799663400E+02 gamma(00000489)=0.123919799663400E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 489 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000489)=0.000000000000000E+00 beta (00000490)=0.134654429509055E+02 gamma(00000490)=0.134654429509055E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 490 z1= 1 0.584956985816953E-03 0.000000000000000E+00 z1= 2 0.229959172369473E-02 0.000000000000000E+00 z1= 3 -.483984554217260E-04 0.000000000000000E+00 alpha(00000490)=0.000000000000000E+00 beta (00000491)=0.124843963688445E+02 gamma(00000491)=0.124843963688445E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 491 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000491)=0.000000000000000E+00 beta (00000492)=0.136307765990276E+02 gamma(00000492)=0.136307765990276E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 492 z1= 1 -.656604698879500E-03 0.000000000000000E+00 z1= 2 -.156512343884427E-02 0.000000000000000E+00 z1= 3 0.489297868718351E-04 0.000000000000000E+00 alpha(00000492)=0.000000000000000E+00 beta (00000493)=0.127166738742377E+02 gamma(00000493)=0.127166738742377E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 493 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000493)=0.000000000000000E+00 beta (00000494)=0.130784797295233E+02 gamma(00000494)=0.130784797295233E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 494 z1= 1 0.615157699481218E-03 0.000000000000000E+00 z1= 2 0.102712592571229E-02 0.000000000000000E+00 z1= 3 -.648974655918540E-04 0.000000000000000E+00 alpha(00000494)=0.000000000000000E+00 beta (00000495)=0.123678863493572E+02 gamma(00000495)=0.123678863493572E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 495 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000495)=0.000000000000000E+00 beta (00000496)=0.133278774469494E+02 gamma(00000496)=0.133278774469494E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 496 z1= 1 -.714861253809998E-03 0.000000000000000E+00 z1= 2 -.384836296670436E-03 0.000000000000000E+00 z1= 3 0.673457167740626E-04 0.000000000000000E+00 alpha(00000496)=0.000000000000000E+00 beta (00000497)=0.124355263932605E+02 gamma(00000497)=0.124355263932605E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 497 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000497)=0.000000000000000E+00 beta (00000498)=0.137483200431710E+02 gamma(00000498)=0.137483200431710E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 498 z1= 1 0.606104254708087E-03 0.000000000000000E+00 z1= 2 -.535396581947747E-04 0.000000000000000E+00 z1= 3 -.762231126569548E-04 0.000000000000000E+00 alpha(00000498)=0.000000000000000E+00 beta (00000499)=0.125725724034039E+02 gamma(00000499)=0.125725724034039E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 499 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000499)=0.000000000000000E+00 beta (00000500)=0.134629466276375E+02 gamma(00000500)=0.134629466276375E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 500 z1= 1 -.738499831824187E-03 0.000000000000000E+00 z1= 2 -.305783981104785E-05 0.000000000000000E+00 z1= 3 0.862216582835068E-04 0.000000000000000E+00 alpha(00000500)=0.000000000000000E+00 beta (00000501)=0.122938431253327E+02 gamma(00000501)=0.122938431253327E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Norm of initial Lanczos vectors= 2.201236114371895 Starting Lanczos loop 3 Lanczos iteration: 1 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal alpha(00000001)=0.000000000000000E+00 beta (00000002)=0.139837239819952E+01 gamma(00000002)=0.139837239819952E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 2 z1= 1 -.105431867736456E-05 0.000000000000000E+00 z1= 2 -.131806396223323E-05 0.000000000000000E+00 z1= 3 0.141270853955648E+01 0.000000000000000E+00 alpha(00000002)=0.000000000000000E+00 beta (00000003)=0.583918983485437E+01 gamma(00000003)=0.583918983485437E+01 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 3 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000003)=0.000000000000000E+00 beta (00000004)=0.140886642877923E+02 gamma(00000004)=0.140886642877923E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 4 z1= 1 0.357157376648372E-06 0.000000000000000E+00 z1= 2 0.539134194799725E-06 0.000000000000000E+00 z1= 3 -.471986142387352E+00 0.000000000000000E+00 alpha(00000004)=0.000000000000000E+00 beta (00000005)=0.136313817244161E+02 gamma(00000005)=0.136313817244161E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 5 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000005)=0.000000000000000E+00 beta (00000006)=0.120975243010006E+02 gamma(00000006)=0.120975243010006E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 6 z1= 1 -.271279730355237E-06 0.000000000000000E+00 z1= 2 -.587348507622419E-06 0.000000000000000E+00 z1= 3 0.472275058349150E+00 0.000000000000000E+00 alpha(00000006)=0.000000000000000E+00 beta (00000007)=0.129753715646553E+02 gamma(00000007)=0.129753715646553E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 7 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000007)=0.000000000000000E+00 beta (00000008)=0.137657892684247E+02 gamma(00000008)=0.137657892684247E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 8 z1= 1 0.882763656110362E-07 0.000000000000000E+00 z1= 2 0.510770255427589E-06 0.000000000000000E+00 z1= 3 -.420320997363079E+00 0.000000000000000E+00 alpha(00000008)=0.000000000000000E+00 beta (00000009)=0.114976560921694E+02 gamma(00000009)=0.114976560921694E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 9 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000009)=0.000000000000000E+00 beta (00000010)=0.144406106240509E+02 gamma(00000010)=0.144406106240509E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 10 z1= 1 0.458820365227628E-07 0.000000000000000E+00 z1= 2 -.532461169295000E-06 0.000000000000000E+00 z1= 3 0.320385799623044E+00 0.000000000000000E+00 alpha(00000010)=0.000000000000000E+00 beta (00000011)=0.114835890570485E+02 gamma(00000011)=0.114835890570485E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 11 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000011)=0.000000000000000E+00 beta (00000012)=0.141509358170520E+02 gamma(00000012)=0.141509358170520E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 12 z1= 1 -.302432405356080E-06 0.000000000000000E+00 z1= 2 0.499052503960025E-06 0.000000000000000E+00 z1= 3 -.249513006796245E+00 0.000000000000000E+00 alpha(00000012)=0.000000000000000E+00 beta (00000013)=0.121763289323395E+02 gamma(00000013)=0.121763289323395E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 13 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000013)=0.000000000000000E+00 beta (00000014)=0.136921198737543E+02 gamma(00000014)=0.136921198737543E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 14 z1= 1 0.305485380985436E-06 0.000000000000000E+00 z1= 2 -.538971670232462E-06 0.000000000000000E+00 z1= 3 0.214072520710603E+00 0.000000000000000E+00 alpha(00000014)=0.000000000000000E+00 beta (00000015)=0.126054408701184E+02 gamma(00000015)=0.126054408701184E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 15 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000015)=0.000000000000000E+00 beta (00000016)=0.132630663523586E+02 gamma(00000016)=0.132630663523586E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 16 z1= 1 -.401795899684834E-06 0.000000000000000E+00 z1= 2 0.509255237696096E-06 0.000000000000000E+00 z1= 3 -.197585465354187E+00 0.000000000000000E+00 alpha(00000016)=0.000000000000000E+00 beta (00000017)=0.126324275794214E+02 gamma(00000017)=0.126324275794214E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 17 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000017)=0.000000000000000E+00 beta (00000018)=0.132916596641760E+02 gamma(00000018)=0.132916596641760E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 18 z1= 1 0.348706447331247E-06 0.000000000000000E+00 z1= 2 -.810775073944114E-06 0.000000000000000E+00 z1= 3 0.183442130010977E+00 0.000000000000000E+00 alpha(00000018)=0.000000000000000E+00 beta (00000019)=0.125782885983466E+02 gamma(00000019)=0.125782885983466E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 19 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000019)=0.000000000000000E+00 beta (00000020)=0.133265822439103E+02 gamma(00000020)=0.133265822439103E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 20 z1= 1 -.286863783217971E-06 0.000000000000000E+00 z1= 2 0.590033660835423E-06 0.000000000000000E+00 z1= 3 -.169455655577085E+00 0.000000000000000E+00 alpha(00000020)=0.000000000000000E+00 beta (00000021)=0.126803212292129E+02 gamma(00000021)=0.126803212292129E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 21 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000021)=0.000000000000000E+00 beta (00000022)=0.135270415037271E+02 gamma(00000022)=0.135270415037271E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 22 z1= 1 -.152547297417680E-06 0.000000000000000E+00 z1= 2 -.258368031063358E-06 0.000000000000000E+00 z1= 3 0.155556253146621E+00 0.000000000000000E+00 alpha(00000022)=0.000000000000000E+00 beta (00000023)=0.127977561102923E+02 gamma(00000023)=0.127977561102923E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 23 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000023)=0.000000000000000E+00 beta (00000024)=0.129391446665789E+02 gamma(00000024)=0.129391446665789E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 24 z1= 1 0.235169470299244E-06 0.000000000000000E+00 z1= 2 0.829847974233083E-06 0.000000000000000E+00 z1= 3 -.150681899755109E+00 0.000000000000000E+00 alpha(00000024)=0.000000000000000E+00 beta (00000025)=0.127075034154896E+02 gamma(00000025)=0.127075034154896E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 25 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000025)=0.000000000000000E+00 beta (00000026)=0.128587930319009E+02 gamma(00000026)=0.128587930319009E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 26 z1= 1 -.494709068958252E-06 0.000000000000000E+00 z1= 2 -.331997209317299E-06 0.000000000000000E+00 z1= 3 0.146080670034400E+00 0.000000000000000E+00 alpha(00000026)=0.000000000000000E+00 beta (00000027)=0.129459034277161E+02 gamma(00000027)=0.129459034277161E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 27 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000027)=0.000000000000000E+00 beta (00000028)=0.129315458129224E+02 gamma(00000028)=0.129315458129224E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 28 z1= 1 0.856903608038254E-06 0.000000000000000E+00 z1= 2 0.156202941501891E-06 0.000000000000000E+00 z1= 3 -.143972748589802E+00 0.000000000000000E+00 alpha(00000028)=0.000000000000000E+00 beta (00000029)=0.128384218474338E+02 gamma(00000029)=0.128384218474338E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 29 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000029)=0.000000000000000E+00 beta (00000030)=0.131774352953749E+02 gamma(00000030)=0.131774352953749E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 30 z1= 1 -.915298919448317E-06 0.000000000000000E+00 z1= 2 -.819223884310064E-06 0.000000000000000E+00 z1= 3 0.138440981039792E+00 0.000000000000000E+00 alpha(00000030)=0.000000000000000E+00 beta (00000031)=0.126980938261913E+02 gamma(00000031)=0.126980938261913E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 31 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000031)=0.000000000000000E+00 beta (00000032)=0.131551483764086E+02 gamma(00000032)=0.131551483764086E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 32 z1= 1 0.113619824685448E-05 0.000000000000000E+00 z1= 2 0.441651089247408E-06 0.000000000000000E+00 z1= 3 -.132129333839497E+00 0.000000000000000E+00 alpha(00000032)=0.000000000000000E+00 beta (00000033)=0.123725192870531E+02 gamma(00000033)=0.123725192870531E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 33 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000033)=0.000000000000000E+00 beta (00000034)=0.135229643737017E+02 gamma(00000034)=0.135229643737017E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 34 z1= 1 -.663681691149415E-06 0.000000000000000E+00 z1= 2 -.956261443440338E-07 0.000000000000000E+00 z1= 3 0.119599676085395E+00 0.000000000000000E+00 alpha(00000034)=0.000000000000000E+00 beta (00000035)=0.123513508672612E+02 gamma(00000035)=0.123513508672612E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 35 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000035)=0.000000000000000E+00 beta (00000036)=0.131882685163227E+02 gamma(00000036)=0.131882685163227E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 36 z1= 1 0.159832010760298E-05 0.000000000000000E+00 z1= 2 -.217603414360201E-06 0.000000000000000E+00 z1= 3 -.110752043100731E+00 0.000000000000000E+00 alpha(00000036)=0.000000000000000E+00 beta (00000037)=0.124684271562668E+02 gamma(00000037)=0.124684271562668E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 37 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000037)=0.000000000000000E+00 beta (00000038)=0.132932271852754E+02 gamma(00000038)=0.132932271852754E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 38 z1= 1 -.158575163904844E-05 0.000000000000000E+00 z1= 2 -.132433850516403E-06 0.000000000000000E+00 z1= 3 0.102632390635020E+00 0.000000000000000E+00 alpha(00000038)=0.000000000000000E+00 beta (00000039)=0.129484737690341E+02 gamma(00000039)=0.129484737690341E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 39 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000039)=0.000000000000000E+00 beta (00000040)=0.132358119729643E+02 gamma(00000040)=0.132358119729643E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 40 z1= 1 0.928600793663383E-06 0.000000000000000E+00 z1= 2 0.775030712948845E-06 0.000000000000000E+00 z1= 3 -.992578796918508E-01 0.000000000000000E+00 alpha(00000040)=0.000000000000000E+00 beta (00000041)=0.128333348890671E+02 gamma(00000041)=0.128333348890671E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 41 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000041)=0.000000000000000E+00 beta (00000042)=0.126750914126063E+02 gamma(00000042)=0.126750914126063E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 42 z1= 1 -.519491508659225E-06 0.000000000000000E+00 z1= 2 -.111393085550039E-05 0.000000000000000E+00 z1= 3 0.993042740312357E-01 0.000000000000000E+00 alpha(00000042)=0.000000000000000E+00 beta (00000043)=0.129621137957747E+02 gamma(00000043)=0.129621137957747E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 43 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000043)=0.000000000000000E+00 beta (00000044)=0.130763312110401E+02 gamma(00000044)=0.130763312110401E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 44 z1= 1 0.102963360395510E-05 0.000000000000000E+00 z1= 2 0.285971064982373E-06 0.000000000000000E+00 z1= 3 -.973492937105239E-01 0.000000000000000E+00 alpha(00000044)=0.000000000000000E+00 beta (00000045)=0.128718985213330E+02 gamma(00000045)=0.128718985213330E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 45 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000045)=0.000000000000000E+00 beta (00000046)=0.131383573562493E+02 gamma(00000046)=0.131383573562493E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 46 z1= 1 -.128685133980247E-05 0.000000000000000E+00 z1= 2 0.193592063329898E-06 0.000000000000000E+00 z1= 3 0.944395509155312E-01 0.000000000000000E+00 alpha(00000046)=0.000000000000000E+00 beta (00000047)=0.124675388091519E+02 gamma(00000047)=0.124675388091519E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 47 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000047)=0.000000000000000E+00 beta (00000048)=0.132106591764677E+02 gamma(00000048)=0.132106591764677E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 48 z1= 1 0.629788765854102E-06 0.000000000000000E+00 z1= 2 0.377890270923794E-06 0.000000000000000E+00 z1= 3 -.886408923539096E-01 0.000000000000000E+00 alpha(00000048)=0.000000000000000E+00 beta (00000049)=0.125331189536575E+02 gamma(00000049)=0.125331189536575E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 49 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000049)=0.000000000000000E+00 beta (00000050)=0.134282436310887E+02 gamma(00000050)=0.134282436310887E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 50 z1= 1 -.629344526332305E-06 0.000000000000000E+00 z1= 2 -.172859180615540E-06 0.000000000000000E+00 z1= 3 0.826370305886715E-01 0.000000000000000E+00 alpha(00000050)=0.000000000000000E+00 beta (00000051)=0.125078764102794E+02 gamma(00000051)=0.125078764102794E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 51 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000051)=0.000000000000000E+00 beta (00000052)=0.134309781457924E+02 gamma(00000052)=0.134309781457924E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 52 z1= 1 0.620501961673403E-06 0.000000000000000E+00 z1= 2 0.582776748489261E-06 0.000000000000000E+00 z1= 3 -.771615722702505E-01 0.000000000000000E+00 alpha(00000052)=0.000000000000000E+00 beta (00000053)=0.124678766380471E+02 gamma(00000053)=0.124678766380471E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 53 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000053)=0.000000000000000E+00 beta (00000054)=0.133576181499276E+02 gamma(00000054)=0.133576181499276E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 54 z1= 1 -.120076645987726E-06 0.000000000000000E+00 z1= 2 -.489177081080541E-06 0.000000000000000E+00 z1= 3 0.723051572609314E-01 0.000000000000000E+00 alpha(00000054)=0.000000000000000E+00 beta (00000055)=0.126450919727416E+02 gamma(00000055)=0.126450919727416E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 55 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000055)=0.000000000000000E+00 beta (00000056)=0.128790000243476E+02 gamma(00000056)=0.128790000243476E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 56 z1= 1 0.302356680977924E-06 0.000000000000000E+00 z1= 2 -.263785308504498E-06 0.000000000000000E+00 z1= 3 -.716332816095646E-01 0.000000000000000E+00 alpha(00000056)=0.000000000000000E+00 beta (00000057)=0.127416557276246E+02 gamma(00000057)=0.127416557276246E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 57 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000057)=0.000000000000000E+00 beta (00000058)=0.132230077611435E+02 gamma(00000058)=0.132230077611435E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 58 z1= 1 -.359219904281106E-06 0.000000000000000E+00 z1= 2 0.540027909272053E-06 0.000000000000000E+00 z1= 3 0.698433837349147E-01 0.000000000000000E+00 alpha(00000058)=0.000000000000000E+00 beta (00000059)=0.127528962208201E+02 gamma(00000059)=0.127528962208201E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 59 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000059)=0.000000000000000E+00 beta (00000060)=0.129595865691982E+02 gamma(00000060)=0.129595865691982E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 60 z1= 1 0.152398783242374E-05 0.000000000000000E+00 z1= 2 -.111582304132725E-05 0.000000000000000E+00 z1= 3 -.698441228588164E-01 0.000000000000000E+00 alpha(00000060)=0.000000000000000E+00 beta (00000061)=0.128510744195772E+02 gamma(00000061)=0.128510744195772E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 61 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000061)=0.000000000000000E+00 beta (00000062)=0.133871346967679E+02 gamma(00000062)=0.133871346967679E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 62 z1= 1 -.139392820041896E-05 0.000000000000000E+00 z1= 2 0.154175644626877E-05 0.000000000000000E+00 z1= 3 0.679883022517945E-01 0.000000000000000E+00 alpha(00000062)=0.000000000000000E+00 beta (00000063)=0.126333187362831E+02 gamma(00000063)=0.126333187362831E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 63 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000063)=0.000000000000000E+00 beta (00000064)=0.133858432712549E+02 gamma(00000064)=0.133858432712549E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 64 z1= 1 0.570885376350986E-06 0.000000000000000E+00 z1= 2 0.333734368751178E-06 0.000000000000000E+00 z1= 3 -.648495310246548E-01 0.000000000000000E+00 alpha(00000064)=0.000000000000000E+00 beta (00000065)=0.121791268101093E+02 gamma(00000065)=0.121791268101093E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 65 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000065)=0.000000000000000E+00 beta (00000066)=0.133449027064214E+02 gamma(00000066)=0.133449027064214E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 66 z1= 1 -.831882685495625E-06 0.000000000000000E+00 z1= 2 -.150962568479772E-05 0.000000000000000E+00 z1= 3 0.593231641661659E-01 0.000000000000000E+00 alpha(00000066)=0.000000000000000E+00 beta (00000067)=0.126994137726510E+02 gamma(00000067)=0.126994137726510E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 67 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000067)=0.000000000000000E+00 beta (00000068)=0.131874148118205E+02 gamma(00000068)=0.131874148118205E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 68 z1= 1 0.127618896739482E-05 0.000000000000000E+00 z1= 2 0.569145720166146E-06 0.000000000000000E+00 z1= 3 -.564910565121981E-01 0.000000000000000E+00 alpha(00000068)=0.000000000000000E+00 beta (00000069)=0.126621204466437E+02 gamma(00000069)=0.126621204466437E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 69 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000069)=0.000000000000000E+00 beta (00000070)=0.133213343574816E+02 gamma(00000070)=0.133213343574816E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 70 z1= 1 -.140046430346813E-05 0.000000000000000E+00 z1= 2 -.201748749168373E-06 0.000000000000000E+00 z1= 3 0.525297068401361E-01 0.000000000000000E+00 alpha(00000070)=0.000000000000000E+00 beta (00000071)=0.126538360929194E+02 gamma(00000071)=0.126538360929194E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 71 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000071)=0.000000000000000E+00 beta (00000072)=0.132712207995738E+02 gamma(00000072)=0.132712207995738E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 72 z1= 1 0.211113905539096E-05 0.000000000000000E+00 z1= 2 0.172034871197941E-06 0.000000000000000E+00 z1= 3 -.485978230125232E-01 0.000000000000000E+00 alpha(00000072)=0.000000000000000E+00 beta (00000073)=0.126966172751216E+02 gamma(00000073)=0.126966172751216E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 73 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000073)=0.000000000000000E+00 beta (00000074)=0.130224154764874E+02 gamma(00000074)=0.130224154764874E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 74 z1= 1 -.172090655574321E-05 0.000000000000000E+00 z1= 2 -.796957624360950E-06 0.000000000000000E+00 z1= 3 0.455522776537798E-01 0.000000000000000E+00 alpha(00000074)=0.000000000000000E+00 beta (00000075)=0.128778363149852E+02 gamma(00000075)=0.128778363149852E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 75 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000075)=0.000000000000000E+00 beta (00000076)=0.132609052949718E+02 gamma(00000076)=0.132609052949718E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 76 z1= 1 0.138218947981549E-05 0.000000000000000E+00 z1= 2 0.111307879868455E-05 0.000000000000000E+00 z1= 3 -.425401683475830E-01 0.000000000000000E+00 alpha(00000076)=0.000000000000000E+00 beta (00000077)=0.127614031845984E+02 gamma(00000077)=0.127614031845984E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 77 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000077)=0.000000000000000E+00 beta (00000078)=0.131375092860439E+02 gamma(00000078)=0.131375092860439E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 78 z1= 1 -.176855655839624E-05 0.000000000000000E+00 z1= 2 -.836284000012679E-06 0.000000000000000E+00 z1= 3 0.395360576991240E-01 0.000000000000000E+00 alpha(00000078)=0.000000000000000E+00 beta (00000079)=0.128833994726751E+02 gamma(00000079)=0.128833994726751E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 79 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000079)=0.000000000000000E+00 beta (00000080)=0.127683133398569E+02 gamma(00000080)=0.127683133398569E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 80 z1= 1 0.307861409710791E-05 0.000000000000000E+00 z1= 2 0.191422530006506E-05 0.000000000000000E+00 z1= 3 -.384135561906002E-01 0.000000000000000E+00 alpha(00000080)=0.000000000000000E+00 beta (00000081)=0.129711378506969E+02 gamma(00000081)=0.129711378506969E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 81 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000081)=0.000000000000000E+00 beta (00000082)=0.131221546713010E+02 gamma(00000082)=0.131221546713010E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 82 z1= 1 -.255028588290170E-05 0.000000000000000E+00 z1= 2 -.386914154463765E-05 0.000000000000000E+00 z1= 3 0.369430549694502E-01 0.000000000000000E+00 alpha(00000082)=0.000000000000000E+00 beta (00000083)=0.126067846021851E+02 gamma(00000083)=0.126067846021851E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 83 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000083)=0.000000000000000E+00 beta (00000084)=0.134495060291953E+02 gamma(00000084)=0.134495060291953E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 84 z1= 1 0.117446718512040E-05 0.000000000000000E+00 z1= 2 0.447740517553496E-05 0.000000000000000E+00 z1= 3 -.338139051821919E-01 0.000000000000000E+00 alpha(00000084)=0.000000000000000E+00 beta (00000085)=0.123891713030377E+02 gamma(00000085)=0.123891713030377E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 85 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000085)=0.000000000000000E+00 beta (00000086)=0.132664272058606E+02 gamma(00000086)=0.132664272058606E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 86 z1= 1 -.121563503923327E-05 0.000000000000000E+00 z1= 2 -.526538240288579E-05 0.000000000000000E+00 z1= 3 0.309371542435528E-01 0.000000000000000E+00 alpha(00000086)=0.000000000000000E+00 beta (00000087)=0.124220295651354E+02 gamma(00000087)=0.124220295651354E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 87 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000087)=0.000000000000000E+00 beta (00000088)=0.132437259622032E+02 gamma(00000088)=0.132437259622032E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 88 z1= 1 0.227206849220539E-05 0.000000000000000E+00 z1= 2 0.606821787878925E-05 0.000000000000000E+00 z1= 3 -.286567739458616E-01 0.000000000000000E+00 alpha(00000088)=0.000000000000000E+00 beta (00000089)=0.125382979219186E+02 gamma(00000089)=0.125382979219186E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 89 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000089)=0.000000000000000E+00 beta (00000090)=0.133110669647026E+02 gamma(00000090)=0.133110669647026E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 90 z1= 1 -.242382341286164E-05 0.000000000000000E+00 z1= 2 -.617348031608676E-05 0.000000000000000E+00 z1= 3 0.269336162780298E-01 0.000000000000000E+00 alpha(00000090)=0.000000000000000E+00 beta (00000091)=0.126848573498736E+02 gamma(00000091)=0.126848573498736E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 91 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000091)=0.000000000000000E+00 beta (00000092)=0.131710485220794E+02 gamma(00000092)=0.131710485220794E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 92 z1= 1 0.188328934317881E-05 0.000000000000000E+00 z1= 2 0.642607240111648E-05 0.000000000000000E+00 z1= 3 -.258130706084623E-01 0.000000000000000E+00 alpha(00000092)=0.000000000000000E+00 beta (00000093)=0.128553974014892E+02 gamma(00000093)=0.128553974014892E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 93 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000093)=0.000000000000000E+00 beta (00000094)=0.131660741523571E+02 gamma(00000094)=0.131660741523571E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 94 z1= 1 -.254593204527176E-05 0.000000000000000E+00 z1= 2 -.501732308123343E-05 0.000000000000000E+00 z1= 3 0.248468988093117E-01 0.000000000000000E+00 alpha(00000094)=0.000000000000000E+00 beta (00000095)=0.128086422369406E+02 gamma(00000095)=0.128086422369406E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 95 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000095)=0.000000000000000E+00 beta (00000096)=0.133488761879108E+02 gamma(00000096)=0.133488761879108E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 96 z1= 1 0.202722408168435E-05 0.000000000000000E+00 z1= 2 0.292316081294570E-05 0.000000000000000E+00 z1= 3 -.234764301656311E-01 0.000000000000000E+00 alpha(00000096)=0.000000000000000E+00 beta (00000097)=0.126797694136714E+02 gamma(00000097)=0.126797694136714E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 97 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000097)=0.000000000000000E+00 beta (00000098)=0.134662413999326E+02 gamma(00000098)=0.134662413999326E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 98 z1= 1 -.124758006453526E-05 0.000000000000000E+00 z1= 2 -.181296504828452E-05 0.000000000000000E+00 z1= 3 0.222396826794031E-01 0.000000000000000E+00 alpha(00000098)=0.000000000000000E+00 beta (00000099)=0.127337321016686E+02 gamma(00000099)=0.127337321016686E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 99 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000099)=0.000000000000000E+00 beta (00000100)=0.134442215302105E+02 gamma(00000100)=0.134442215302105E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 100 z1= 1 0.159814128151698E-05 0.000000000000000E+00 z1= 2 0.108536282032720E-05 0.000000000000000E+00 z1= 3 -.215475679392887E-01 0.000000000000000E+00 alpha(00000100)=0.000000000000000E+00 beta (00000101)=0.127405269279041E+02 gamma(00000101)=0.127405269279041E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 101 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000101)=0.000000000000000E+00 beta (00000102)=0.132552085636852E+02 gamma(00000102)=0.132552085636852E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 102 z1= 1 -.229339754553382E-05 0.000000000000000E+00 z1= 2 0.477656426148846E-06 0.000000000000000E+00 z1= 3 0.211710793797022E-01 0.000000000000000E+00 alpha(00000102)=0.000000000000000E+00 beta (00000103)=0.126946911912446E+02 gamma(00000103)=0.126946911912446E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 103 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000103)=0.000000000000000E+00 beta (00000104)=0.130545539624966E+02 gamma(00000104)=0.130545539624966E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 104 z1= 1 0.260599973364540E-05 0.000000000000000E+00 z1= 2 -.173028687194365E-05 0.000000000000000E+00 z1= 3 -.204060099974212E-01 0.000000000000000E+00 alpha(00000104)=0.000000000000000E+00 beta (00000105)=0.124334489790416E+02 gamma(00000105)=0.124334489790416E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 105 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000105)=0.000000000000000E+00 beta (00000106)=0.131208770102910E+02 gamma(00000106)=0.131208770102910E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 106 z1= 1 -.215225385511006E-05 0.000000000000000E+00 z1= 2 0.245267766478888E-05 0.000000000000000E+00 z1= 3 0.185691513440850E-01 0.000000000000000E+00 alpha(00000106)=0.000000000000000E+00 beta (00000107)=0.125419163939340E+02 gamma(00000107)=0.125419163939340E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 107 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000107)=0.000000000000000E+00 beta (00000108)=0.129506493894274E+02 gamma(00000108)=0.129506493894274E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 108 z1= 1 0.217741942052903E-05 0.000000000000000E+00 z1= 2 -.371793939425138E-05 0.000000000000000E+00 z1= 3 -.166694330215543E-01 0.000000000000000E+00 alpha(00000108)=0.000000000000000E+00 beta (00000109)=0.126574414396952E+02 gamma(00000109)=0.126574414396952E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 109 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000109)=0.000000000000000E+00 beta (00000110)=0.128521516452742E+02 gamma(00000110)=0.128521516452742E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 110 z1= 1 -.170851244705723E-05 0.000000000000000E+00 z1= 2 0.247574663574714E-05 0.000000000000000E+00 z1= 3 0.147859083837396E-01 0.000000000000000E+00 alpha(00000110)=0.000000000000000E+00 beta (00000111)=0.121378777022171E+02 gamma(00000111)=0.121378777022171E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 111 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000111)=0.000000000000000E+00 beta (00000112)=0.130626799165031E+02 gamma(00000112)=0.130626799165031E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 112 z1= 1 0.146309604908313E-05 0.000000000000000E+00 z1= 2 -.207906811178619E-05 0.000000000000000E+00 z1= 3 -.125459238728307E-01 0.000000000000000E+00 alpha(00000112)=0.000000000000000E+00 beta (00000113)=0.123827991293811E+02 gamma(00000113)=0.123827991293811E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 113 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000113)=0.000000000000000E+00 beta (00000114)=0.131503236298141E+02 gamma(00000114)=0.131503236298141E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 114 z1= 1 -.287603608436723E-05 0.000000000000000E+00 z1= 2 -.227049970171552E-06 0.000000000000000E+00 z1= 3 0.110388062910752E-01 0.000000000000000E+00 alpha(00000114)=0.000000000000000E+00 beta (00000115)=0.126761359145671E+02 gamma(00000115)=0.126761359145671E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 115 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000115)=0.000000000000000E+00 beta (00000116)=0.134862923559389E+02 gamma(00000116)=0.134862923559389E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 116 z1= 1 0.200008026924161E-05 0.000000000000000E+00 z1= 2 0.269669142957018E-05 0.000000000000000E+00 z1= 3 -.990635812146677E-02 0.000000000000000E+00 alpha(00000116)=0.000000000000000E+00 beta (00000117)=0.125982001568146E+02 gamma(00000117)=0.125982001568146E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 117 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000117)=0.000000000000000E+00 beta (00000118)=0.129693570585276E+02 gamma(00000118)=0.129693570585276E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 118 z1= 1 -.141960637046605E-05 0.000000000000000E+00 z1= 2 -.635688361117832E-05 0.000000000000000E+00 z1= 3 0.976331663413242E-02 0.000000000000000E+00 alpha(00000118)=0.000000000000000E+00 beta (00000119)=0.121788965744882E+02 gamma(00000119)=0.121788965744882E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 119 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000119)=0.000000000000000E+00 beta (00000120)=0.130017998972927E+02 gamma(00000120)=0.130017998972927E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 120 z1= 1 0.403196377695033E-06 0.000000000000000E+00 z1= 2 0.100315917284632E-04 0.000000000000000E+00 z1= 3 -.926368677061886E-02 0.000000000000000E+00 alpha(00000120)=0.000000000000000E+00 beta (00000121)=0.126748535055662E+02 gamma(00000121)=0.126748535055662E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 121 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000121)=0.000000000000000E+00 beta (00000122)=0.136877465133448E+02 gamma(00000122)=0.136877465133448E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 122 z1= 1 -.148468985606377E-05 0.000000000000000E+00 z1= 2 -.144881655283916E-04 0.000000000000000E+00 z1= 3 0.860917601953647E-02 0.000000000000000E+00 alpha(00000122)=0.000000000000000E+00 beta (00000123)=0.127026430662887E+02 gamma(00000123)=0.127026430662887E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 123 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000123)=0.000000000000000E+00 beta (00000124)=0.134155433325831E+02 gamma(00000124)=0.134155433325831E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 124 z1= 1 0.252602483397188E-05 0.000000000000000E+00 z1= 2 0.163627085706719E-04 0.000000000000000E+00 z1= 3 -.825317208371300E-02 0.000000000000000E+00 alpha(00000124)=0.000000000000000E+00 beta (00000125)=0.123036405785276E+02 gamma(00000125)=0.123036405785276E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 125 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000125)=0.000000000000000E+00 beta (00000126)=0.133202767203304E+02 gamma(00000126)=0.133202767203304E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 126 z1= 1 -.275524957290304E-05 0.000000000000000E+00 z1= 2 -.207705243787214E-04 0.000000000000000E+00 z1= 3 0.778251823674074E-02 0.000000000000000E+00 alpha(00000126)=0.000000000000000E+00 beta (00000127)=0.129200435319801E+02 gamma(00000127)=0.129200435319801E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 127 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000127)=0.000000000000000E+00 beta (00000128)=0.131944640503957E+02 gamma(00000128)=0.131944640503957E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 128 z1= 1 -.268439238613788E-07 0.000000000000000E+00 z1= 2 0.255157154593789E-04 0.000000000000000E+00 z1= 3 -.804840119749800E-02 0.000000000000000E+00 alpha(00000128)=0.000000000000000E+00 beta (00000129)=0.131950890995003E+02 gamma(00000129)=0.131950890995003E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 129 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000129)=0.000000000000000E+00 beta (00000130)=0.132240460028896E+02 gamma(00000130)=0.132240460028896E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 130 z1= 1 0.292765160938722E-06 0.000000000000000E+00 z1= 2 -.291309930396057E-04 0.000000000000000E+00 z1= 3 0.834129518437296E-02 0.000000000000000E+00 alpha(00000130)=0.000000000000000E+00 beta (00000131)=0.126030860266092E+02 gamma(00000131)=0.126030860266092E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 131 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000131)=0.000000000000000E+00 beta (00000132)=0.130368209986143E+02 gamma(00000132)=0.130368209986143E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 132 z1= 1 -.336527768356448E-06 0.000000000000000E+00 z1= 2 0.321793083148179E-04 0.000000000000000E+00 z1= 3 -.824255252986062E-02 0.000000000000000E+00 alpha(00000132)=0.000000000000000E+00 beta (00000133)=0.123214366501471E+02 gamma(00000133)=0.123214366501471E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 133 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000133)=0.000000000000000E+00 beta (00000134)=0.131101408145072E+02 gamma(00000134)=0.131101408145072E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 134 z1= 1 -.123848292212935E-06 0.000000000000000E+00 z1= 2 -.347296114450112E-04 0.000000000000000E+00 z1= 3 0.775339935173384E-02 0.000000000000000E+00 alpha(00000134)=0.000000000000000E+00 beta (00000135)=0.128059201651242E+02 gamma(00000135)=0.128059201651242E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 135 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000135)=0.000000000000000E+00 beta (00000136)=0.129379726287944E+02 gamma(00000136)=0.129379726287944E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 136 z1= 1 0.303681660372896E-06 0.000000000000000E+00 z1= 2 0.392040865257977E-04 0.000000000000000E+00 z1= 3 -.769494567661435E-02 0.000000000000000E+00 alpha(00000136)=0.000000000000000E+00 beta (00000137)=0.133670299052382E+02 gamma(00000137)=0.133670299052382E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 137 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000137)=0.000000000000000E+00 beta (00000138)=0.131131788370750E+02 gamma(00000138)=0.131131788370750E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 138 z1= 1 -.192499332288688E-05 0.000000000000000E+00 z1= 2 -.425929480008568E-04 0.000000000000000E+00 z1= 3 0.814974990460011E-02 0.000000000000000E+00 alpha(00000138)=0.000000000000000E+00 beta (00000139)=0.128246833961262E+02 gamma(00000139)=0.128246833961262E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 139 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000139)=0.000000000000000E+00 beta (00000140)=0.128656508416132E+02 gamma(00000140)=0.128656508416132E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 140 z1= 1 0.307961210488475E-05 0.000000000000000E+00 z1= 2 0.441070297575881E-04 0.000000000000000E+00 z1= 3 -.836253450028533E-02 0.000000000000000E+00 alpha(00000140)=0.000000000000000E+00 beta (00000141)=0.127845958777308E+02 gamma(00000141)=0.127845958777308E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 141 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000141)=0.000000000000000E+00 beta (00000142)=0.129512094669553E+02 gamma(00000142)=0.129512094669553E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 142 z1= 1 -.369239207370669E-05 0.000000000000000E+00 z1= 2 -.444240571045450E-04 0.000000000000000E+00 z1= 3 0.802291558292726E-02 0.000000000000000E+00 alpha(00000142)=0.000000000000000E+00 beta (00000143)=0.128292384401683E+02 gamma(00000143)=0.128292384401683E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 143 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000143)=0.000000000000000E+00 beta (00000144)=0.129893595866302E+02 gamma(00000144)=0.129893595866302E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 144 z1= 1 0.356086823386393E-05 0.000000000000000E+00 z1= 2 0.484690267449440E-04 0.000000000000000E+00 z1= 3 -.740215764017707E-02 0.000000000000000E+00 alpha(00000144)=0.000000000000000E+00 beta (00000145)=0.123294482638681E+02 gamma(00000145)=0.123294482638681E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 145 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000145)=0.000000000000000E+00 beta (00000146)=0.131743249546646E+02 gamma(00000146)=0.131743249546646E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 146 z1= 1 -.324208978051471E-05 0.000000000000000E+00 z1= 2 -.487756231859958E-04 0.000000000000000E+00 z1= 3 0.615232495071900E-02 0.000000000000000E+00 alpha(00000146)=0.000000000000000E+00 beta (00000147)=0.126255321281442E+02 gamma(00000147)=0.126255321281442E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 147 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000147)=0.000000000000000E+00 beta (00000148)=0.130075216501360E+02 gamma(00000148)=0.130075216501360E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 148 z1= 1 0.467650081889071E-05 0.000000000000000E+00 z1= 2 0.484480942942136E-04 0.000000000000000E+00 z1= 3 -.550198982876417E-02 0.000000000000000E+00 alpha(00000148)=0.000000000000000E+00 beta (00000149)=0.129826481144311E+02 gamma(00000149)=0.129826481144311E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 149 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000149)=0.000000000000000E+00 beta (00000150)=0.132678188355717E+02 gamma(00000150)=0.132678188355717E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 150 z1= 1 -.434491790851199E-05 0.000000000000000E+00 z1= 2 -.500508492074263E-04 0.000000000000000E+00 z1= 3 0.561758605605218E-02 0.000000000000000E+00 alpha(00000150)=0.000000000000000E+00 beta (00000151)=0.129561388752060E+02 gamma(00000151)=0.129561388752060E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 151 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000151)=0.000000000000000E+00 beta (00000152)=0.129465009366649E+02 gamma(00000152)=0.129465009366649E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 152 z1= 1 0.192420689336024E-05 0.000000000000000E+00 z1= 2 0.546386108580531E-04 0.000000000000000E+00 z1= 3 -.631266531601693E-02 0.000000000000000E+00 alpha(00000152)=0.000000000000000E+00 beta (00000153)=0.128942079826085E+02 gamma(00000153)=0.128942079826085E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 153 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000153)=0.000000000000000E+00 beta (00000154)=0.130452950977025E+02 gamma(00000154)=0.130452950977025E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 154 z1= 1 0.104809440266995E-05 0.000000000000000E+00 z1= 2 -.579639019385024E-04 0.000000000000000E+00 z1= 3 0.703470689972860E-02 0.000000000000000E+00 alpha(00000154)=0.000000000000000E+00 beta (00000155)=0.128405955139283E+02 gamma(00000155)=0.128405955139283E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 155 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000155)=0.000000000000000E+00 beta (00000156)=0.130687990401670E+02 gamma(00000156)=0.130687990401670E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 156 z1= 1 -.166134714732393E-05 0.000000000000000E+00 z1= 2 0.587333136595383E-04 0.000000000000000E+00 z1= 3 -.776836016185389E-02 0.000000000000000E+00 alpha(00000156)=0.000000000000000E+00 beta (00000157)=0.122324581754714E+02 gamma(00000157)=0.122324581754714E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 157 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000157)=0.000000000000000E+00 beta (00000158)=0.135002516060941E+02 gamma(00000158)=0.135002516060941E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 158 z1= 1 0.268249119140780E-05 0.000000000000000E+00 z1= 2 -.553875856951276E-04 0.000000000000000E+00 z1= 3 0.794956965999963E-02 0.000000000000000E+00 alpha(00000158)=0.000000000000000E+00 beta (00000159)=0.122560434434980E+02 gamma(00000159)=0.122560434434980E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 159 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000159)=0.000000000000000E+00 beta (00000160)=0.132783164255353E+02 gamma(00000160)=0.132783164255353E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 160 z1= 1 -.678478590463273E-05 0.000000000000000E+00 z1= 2 0.545959458434545E-04 0.000000000000000E+00 z1= 3 -.850333503773534E-02 0.000000000000000E+00 alpha(00000160)=0.000000000000000E+00 beta (00000161)=0.125846433157087E+02 gamma(00000161)=0.125846433157087E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 161 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000161)=0.000000000000000E+00 beta (00000162)=0.130976799370043E+02 gamma(00000162)=0.130976799370043E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 162 z1= 1 0.860782102728858E-05 0.000000000000000E+00 z1= 2 -.559849984013231E-04 0.000000000000000E+00 z1= 3 0.939694381299391E-02 0.000000000000000E+00 alpha(00000162)=0.000000000000000E+00 beta (00000163)=0.128512530581951E+02 gamma(00000163)=0.128512530581951E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 163 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000163)=0.000000000000000E+00 beta (00000164)=0.128966160104211E+02 gamma(00000164)=0.128966160104211E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 164 z1= 1 -.124244287872703E-04 0.000000000000000E+00 z1= 2 0.577543890767257E-04 0.000000000000000E+00 z1= 3 -.103858513770845E-01 0.000000000000000E+00 alpha(00000164)=0.000000000000000E+00 beta (00000165)=0.127259338565780E+02 gamma(00000165)=0.127259338565780E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 165 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000165)=0.000000000000000E+00 beta (00000166)=0.132449636434479E+02 gamma(00000166)=0.132449636434479E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 166 z1= 1 0.144360450092553E-04 0.000000000000000E+00 z1= 2 -.561909117962114E-04 0.000000000000000E+00 z1= 3 0.107895747869330E-01 0.000000000000000E+00 alpha(00000166)=0.000000000000000E+00 beta (00000167)=0.129450224759888E+02 gamma(00000167)=0.129450224759888E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 167 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000167)=0.000000000000000E+00 beta (00000168)=0.133165933002863E+02 gamma(00000168)=0.133165933002863E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 168 z1= 1 -.145846872944163E-04 0.000000000000000E+00 z1= 2 0.550973753991220E-04 0.000000000000000E+00 z1= 3 -.112630794536690E-01 0.000000000000000E+00 alpha(00000168)=0.000000000000000E+00 beta (00000169)=0.125924685067647E+02 gamma(00000169)=0.125924685067647E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 169 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000169)=0.000000000000000E+00 beta (00000170)=0.133602828222706E+02 gamma(00000170)=0.133602828222706E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 170 z1= 1 0.139925648038846E-04 0.000000000000000E+00 z1= 2 -.545881460144870E-04 0.000000000000000E+00 z1= 3 0.113688590450980E-01 0.000000000000000E+00 alpha(00000170)=0.000000000000000E+00 beta (00000171)=0.125392077094616E+02 gamma(00000171)=0.125392077094616E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 171 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000171)=0.000000000000000E+00 beta (00000172)=0.131771290221751E+02 gamma(00000172)=0.131771290221751E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 172 z1= 1 -.133092426873601E-04 0.000000000000000E+00 z1= 2 0.541263497292107E-04 0.000000000000000E+00 z1= 3 -.112389529029617E-01 0.000000000000000E+00 alpha(00000172)=0.000000000000000E+00 beta (00000173)=0.125215956266208E+02 gamma(00000173)=0.125215956266208E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 173 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000173)=0.000000000000000E+00 beta (00000174)=0.126804119082217E+02 gamma(00000174)=0.126804119082217E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 174 z1= 1 0.112263779062840E-04 0.000000000000000E+00 z1= 2 -.557661626360292E-04 0.000000000000000E+00 z1= 3 0.111183666976675E-01 0.000000000000000E+00 alpha(00000174)=0.000000000000000E+00 beta (00000175)=0.126873789147260E+02 gamma(00000175)=0.126873789147260E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 175 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000175)=0.000000000000000E+00 beta (00000176)=0.131960364350051E+02 gamma(00000176)=0.131960364350051E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 176 z1= 1 -.802946572586575E-05 0.000000000000000E+00 z1= 2 0.548044260552001E-04 0.000000000000000E+00 z1= 3 -.102137416056525E-01 0.000000000000000E+00 alpha(00000176)=0.000000000000000E+00 beta (00000177)=0.129359244945982E+02 gamma(00000177)=0.129359244945982E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 177 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000177)=0.000000000000000E+00 beta (00000178)=0.131378158728870E+02 gamma(00000178)=0.131378158728870E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 178 z1= 1 0.642101518134235E-05 0.000000000000000E+00 z1= 2 -.564012361094322E-04 0.000000000000000E+00 z1= 3 0.970287628799372E-02 0.000000000000000E+00 alpha(00000178)=0.000000000000000E+00 beta (00000179)=0.127167689377621E+02 gamma(00000179)=0.127167689377621E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 179 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000179)=0.000000000000000E+00 beta (00000180)=0.134838469153872E+02 gamma(00000180)=0.134838469153872E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 180 z1= 1 -.370715406673738E-05 0.000000000000000E+00 z1= 2 0.568519562409087E-04 0.000000000000000E+00 z1= 3 -.923159740142752E-02 0.000000000000000E+00 alpha(00000180)=0.000000000000000E+00 beta (00000181)=0.126266542277418E+02 gamma(00000181)=0.126266542277418E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 181 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000181)=0.000000000000000E+00 beta (00000182)=0.131747802933576E+02 gamma(00000182)=0.131747802933576E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 182 z1= 1 0.496698727314943E-05 0.000000000000000E+00 z1= 2 -.557377477178047E-04 0.000000000000000E+00 z1= 3 0.922791759782242E-02 0.000000000000000E+00 alpha(00000182)=0.000000000000000E+00 beta (00000183)=0.125205301538150E+02 gamma(00000183)=0.125205301538150E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 183 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000183)=0.000000000000000E+00 beta (00000184)=0.132580365018391E+02 gamma(00000184)=0.132580365018391E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 184 z1= 1 -.195388081511753E-05 0.000000000000000E+00 z1= 2 0.568765406222752E-04 0.000000000000000E+00 z1= 3 -.925881947309587E-02 0.000000000000000E+00 alpha(00000184)=0.000000000000000E+00 beta (00000185)=0.126474278133671E+02 gamma(00000185)=0.126474278133671E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 185 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000185)=0.000000000000000E+00 beta (00000186)=0.135763537702825E+02 gamma(00000186)=0.135763537702825E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 186 z1= 1 0.167035359098879E-05 0.000000000000000E+00 z1= 2 -.560814383084997E-04 0.000000000000000E+00 z1= 3 0.901455711805435E-02 0.000000000000000E+00 alpha(00000186)=0.000000000000000E+00 beta (00000187)=0.130521270568950E+02 gamma(00000187)=0.130521270568950E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 187 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000187)=0.000000000000000E+00 beta (00000188)=0.129654509440539E+02 gamma(00000188)=0.129654509440539E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 188 z1= 1 -.101154826491899E-05 0.000000000000000E+00 z1= 2 0.623293089035471E-04 0.000000000000000E+00 z1= 3 -.943043574490165E-02 0.000000000000000E+00 alpha(00000188)=0.000000000000000E+00 beta (00000189)=0.127177894424911E+02 gamma(00000189)=0.127177894424911E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 189 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000189)=0.000000000000000E+00 beta (00000190)=0.131136665051804E+02 gamma(00000190)=0.131136665051804E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 190 z1= 1 0.415953091460964E-05 0.000000000000000E+00 z1= 2 -.652184629930826E-04 0.000000000000000E+00 z1= 3 0.950483967391579E-02 0.000000000000000E+00 alpha(00000190)=0.000000000000000E+00 beta (00000191)=0.126222400644095E+02 gamma(00000191)=0.126222400644095E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 191 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000191)=0.000000000000000E+00 beta (00000192)=0.132258852775799E+02 gamma(00000192)=0.132258852775799E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 192 z1= 1 -.242251613474857E-05 0.000000000000000E+00 z1= 2 0.665194082539760E-04 0.000000000000000E+00 z1= 3 -.925115482145934E-02 0.000000000000000E+00 alpha(00000192)=0.000000000000000E+00 beta (00000193)=0.124932818271903E+02 gamma(00000193)=0.124932818271903E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 193 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000193)=0.000000000000000E+00 beta (00000194)=0.131696760816112E+02 gamma(00000194)=0.131696760816112E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 194 z1= 1 0.235404866968263E-05 0.000000000000000E+00 z1= 2 -.655802605920384E-04 0.000000000000000E+00 z1= 3 0.862940332729312E-02 0.000000000000000E+00 alpha(00000194)=0.000000000000000E+00 beta (00000195)=0.124689906983473E+02 gamma(00000195)=0.124689906983473E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 195 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000195)=0.000000000000000E+00 beta (00000196)=0.132546579387359E+02 gamma(00000196)=0.132546579387359E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 196 z1= 1 -.325269272125962E-05 0.000000000000000E+00 z1= 2 0.670153799077259E-04 0.000000000000000E+00 z1= 3 -.785277076103647E-02 0.000000000000000E+00 alpha(00000196)=0.000000000000000E+00 beta (00000197)=0.119622893997114E+02 gamma(00000197)=0.119622893997114E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 197 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000197)=0.000000000000000E+00 beta (00000198)=0.130597690088841E+02 gamma(00000198)=0.130597690088841E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 198 z1= 1 0.436328136076592E-05 0.000000000000000E+00 z1= 2 -.638602116091141E-04 0.000000000000000E+00 z1= 3 0.739707140834354E-02 0.000000000000000E+00 alpha(00000198)=0.000000000000000E+00 beta (00000199)=0.127713287653307E+02 gamma(00000199)=0.127713287653307E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 199 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000199)=0.000000000000000E+00 beta (00000200)=0.131471501288193E+02 gamma(00000200)=0.131471501288193E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 200 z1= 1 -.419202516724923E-05 0.000000000000000E+00 z1= 2 0.631560161689626E-04 0.000000000000000E+00 z1= 3 -.797015467517566E-02 0.000000000000000E+00 alpha(00000200)=0.000000000000000E+00 beta (00000201)=0.128029443154331E+02 gamma(00000201)=0.128029443154331E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 201 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000201)=0.000000000000000E+00 beta (00000202)=0.132806776248060E+02 gamma(00000202)=0.132806776248060E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 202 z1= 1 0.250010695981612E-05 0.000000000000000E+00 z1= 2 -.613994920896264E-04 0.000000000000000E+00 z1= 3 0.872798363757188E-02 0.000000000000000E+00 alpha(00000202)=0.000000000000000E+00 beta (00000203)=0.128101506981280E+02 gamma(00000203)=0.128101506981280E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 203 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000203)=0.000000000000000E+00 beta (00000204)=0.128418919799153E+02 gamma(00000204)=0.128418919799153E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 204 z1= 1 0.204939660640696E-05 0.000000000000000E+00 z1= 2 0.591498944214135E-04 0.000000000000000E+00 z1= 3 -.937445359126264E-02 0.000000000000000E+00 alpha(00000204)=0.000000000000000E+00 beta (00000205)=0.124866818744698E+02 gamma(00000205)=0.124866818744698E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 205 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000205)=0.000000000000000E+00 beta (00000206)=0.131206282889412E+02 gamma(00000206)=0.131206282889412E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 206 z1= 1 -.559374863795417E-05 0.000000000000000E+00 z1= 2 -.561611274210525E-04 0.000000000000000E+00 z1= 3 0.917020527818911E-02 0.000000000000000E+00 alpha(00000206)=0.000000000000000E+00 beta (00000207)=0.128704732693694E+02 gamma(00000207)=0.128704732693694E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 207 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000207)=0.000000000000000E+00 beta (00000208)=0.130414353628612E+02 gamma(00000208)=0.130414353628612E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 208 z1= 1 0.650440825969434E-05 0.000000000000000E+00 z1= 2 0.542929401129611E-04 0.000000000000000E+00 z1= 3 -.871062149253240E-02 0.000000000000000E+00 alpha(00000208)=0.000000000000000E+00 beta (00000209)=0.128216892736090E+02 gamma(00000209)=0.128216892736090E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 209 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000209)=0.000000000000000E+00 beta (00000210)=0.136523122181365E+02 gamma(00000210)=0.136523122181365E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 210 z1= 1 -.762417661826745E-05 0.000000000000000E+00 z1= 2 -.514065058810925E-04 0.000000000000000E+00 z1= 3 0.755239423979145E-02 0.000000000000000E+00 alpha(00000210)=0.000000000000000E+00 beta (00000211)=0.130620637730660E+02 gamma(00000211)=0.130620637730660E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 211 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000211)=0.000000000000000E+00 beta (00000212)=0.130376276546009E+02 gamma(00000212)=0.130376276546009E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 212 z1= 1 0.997310737902378E-05 0.000000000000000E+00 z1= 2 0.490967590663879E-04 0.000000000000000E+00 z1= 3 -.709747509823946E-02 0.000000000000000E+00 alpha(00000212)=0.000000000000000E+00 beta (00000213)=0.125429518677444E+02 gamma(00000213)=0.125429518677444E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 213 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000213)=0.000000000000000E+00 beta (00000214)=0.134490517759669E+02 gamma(00000214)=0.134490517759669E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 214 z1= 1 -.103723824829270E-04 0.000000000000000E+00 z1= 2 -.463594997643466E-04 0.000000000000000E+00 z1= 3 0.639034654071635E-02 0.000000000000000E+00 alpha(00000214)=0.000000000000000E+00 beta (00000215)=0.126334836262389E+02 gamma(00000215)=0.126334836262389E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 215 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000215)=0.000000000000000E+00 beta (00000216)=0.130192902305288E+02 gamma(00000216)=0.130192902305288E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 216 z1= 1 0.102984564242934E-04 0.000000000000000E+00 z1= 2 0.436533022689353E-04 0.000000000000000E+00 z1= 3 -.622074022357438E-02 0.000000000000000E+00 alpha(00000216)=0.000000000000000E+00 beta (00000217)=0.132513391687421E+02 gamma(00000217)=0.132513391687421E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 217 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000217)=0.000000000000000E+00 beta (00000218)=0.130089055523710E+02 gamma(00000218)=0.130089055523710E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 218 z1= 1 -.103906557319712E-04 0.000000000000000E+00 z1= 2 -.455970343858196E-04 0.000000000000000E+00 z1= 3 0.620825517660967E-02 0.000000000000000E+00 alpha(00000218)=0.000000000000000E+00 beta (00000219)=0.122657740218464E+02 gamma(00000219)=0.122657740218464E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 219 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000219)=0.000000000000000E+00 beta (00000220)=0.131201478742246E+02 gamma(00000220)=0.131201478742246E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 220 z1= 1 0.107589366102168E-04 0.000000000000000E+00 z1= 2 0.431941942062706E-04 0.000000000000000E+00 z1= 3 -.587646445864841E-02 0.000000000000000E+00 alpha(00000220)=0.000000000000000E+00 beta (00000221)=0.118759818110602E+02 gamma(00000221)=0.118759818110602E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 221 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000221)=0.000000000000000E+00 beta (00000222)=0.131076475234127E+02 gamma(00000222)=0.131076475234127E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 222 z1= 1 -.765509261573438E-05 0.000000000000000E+00 z1= 2 -.386285941296072E-04 0.000000000000000E+00 z1= 3 0.565601751269395E-02 0.000000000000000E+00 alpha(00000222)=0.000000000000000E+00 beta (00000223)=0.127482107636939E+02 gamma(00000223)=0.127482107636939E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 223 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000223)=0.000000000000000E+00 beta (00000224)=0.138155266570775E+02 gamma(00000224)=0.138155266570775E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 224 z1= 1 0.486044536738130E-05 0.000000000000000E+00 z1= 2 0.358182378077404E-04 0.000000000000000E+00 z1= 3 -.531394017514331E-02 0.000000000000000E+00 alpha(00000224)=0.000000000000000E+00 beta (00000225)=0.125336201538739E+02 gamma(00000225)=0.125336201538739E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 225 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000225)=0.000000000000000E+00 beta (00000226)=0.128453080495099E+02 gamma(00000226)=0.128453080495099E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 226 z1= 1 -.265123472121924E-05 0.000000000000000E+00 z1= 2 -.349777416126395E-04 0.000000000000000E+00 z1= 3 0.477930597599313E-02 0.000000000000000E+00 alpha(00000226)=0.000000000000000E+00 beta (00000227)=0.125176098985249E+02 gamma(00000227)=0.125176098985249E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 227 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000227)=0.000000000000000E+00 beta (00000228)=0.129064262321383E+02 gamma(00000228)=0.129064262321383E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 228 z1= 1 0.115123120246203E-05 0.000000000000000E+00 z1= 2 0.314590503833209E-04 0.000000000000000E+00 z1= 3 -.381103804417718E-02 0.000000000000000E+00 alpha(00000228)=0.000000000000000E+00 beta (00000229)=0.125566367672159E+02 gamma(00000229)=0.125566367672159E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 229 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000229)=0.000000000000000E+00 beta (00000230)=0.130816986622765E+02 gamma(00000230)=0.130816986622765E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 230 z1= 1 0.307989105554165E-05 0.000000000000000E+00 z1= 2 -.281499218659392E-04 0.000000000000000E+00 z1= 3 0.307993693869672E-02 0.000000000000000E+00 alpha(00000230)=0.000000000000000E+00 beta (00000231)=0.129150586542326E+02 gamma(00000231)=0.129150586542326E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 231 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000231)=0.000000000000000E+00 beta (00000232)=0.137452726339952E+02 gamma(00000232)=0.137452726339952E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 232 z1= 1 -.742865124125675E-05 0.000000000000000E+00 z1= 2 0.296617321527908E-04 0.000000000000000E+00 z1= 3 -.261591126329504E-02 0.000000000000000E+00 alpha(00000232)=0.000000000000000E+00 beta (00000233)=0.126127399723774E+02 gamma(00000233)=0.126127399723774E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 233 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000233)=0.000000000000000E+00 beta (00000234)=0.134177467758241E+02 gamma(00000234)=0.134177467758241E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 234 z1= 1 0.103828635523086E-04 0.000000000000000E+00 z1= 2 -.258934695848880E-04 0.000000000000000E+00 z1= 3 0.236994677698346E-02 0.000000000000000E+00 alpha(00000234)=0.000000000000000E+00 beta (00000235)=0.127967833474593E+02 gamma(00000235)=0.127967833474593E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 235 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000235)=0.000000000000000E+00 beta (00000236)=0.127056477339837E+02 gamma(00000236)=0.127056477339837E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 236 z1= 1 -.117149788473022E-04 0.000000000000000E+00 z1= 2 0.231652850077997E-04 0.000000000000000E+00 z1= 3 -.227351384186329E-02 0.000000000000000E+00 alpha(00000236)=0.000000000000000E+00 beta (00000237)=0.123761259006128E+02 gamma(00000237)=0.123761259006128E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 237 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000237)=0.000000000000000E+00 beta (00000238)=0.136504279759975E+02 gamma(00000238)=0.136504279759975E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 238 z1= 1 0.121741432149069E-04 0.000000000000000E+00 z1= 2 -.162187168999909E-04 0.000000000000000E+00 z1= 3 0.172194405164760E-02 0.000000000000000E+00 alpha(00000238)=0.000000000000000E+00 beta (00000239)=0.128813175234867E+02 gamma(00000239)=0.128813175234867E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 239 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000239)=0.000000000000000E+00 beta (00000240)=0.138469996109794E+02 gamma(00000240)=0.138469996109794E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 240 z1= 1 -.164107903547258E-04 0.000000000000000E+00 z1= 2 0.116230532625765E-04 0.000000000000000E+00 z1= 3 -.118153001192753E-02 0.000000000000000E+00 alpha(00000240)=0.000000000000000E+00 beta (00000241)=0.127398813669943E+02 gamma(00000241)=0.127398813669943E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 241 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000241)=0.000000000000000E+00 beta (00000242)=0.133360601110006E+02 gamma(00000242)=0.133360601110006E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 242 z1= 1 0.177799239069609E-04 0.000000000000000E+00 z1= 2 -.112741202543686E-04 0.000000000000000E+00 z1= 3 0.891258304847802E-03 0.000000000000000E+00 alpha(00000242)=0.000000000000000E+00 beta (00000243)=0.120616228548236E+02 gamma(00000243)=0.120616228548236E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 243 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000243)=0.000000000000000E+00 beta (00000244)=0.133296916622024E+02 gamma(00000244)=0.133296916622024E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 244 z1= 1 -.233443300510093E-04 0.000000000000000E+00 z1= 2 0.981763923398721E-05 0.000000000000000E+00 z1= 3 -.817910663476244E-03 0.000000000000000E+00 alpha(00000244)=0.000000000000000E+00 beta (00000245)=0.123608691337411E+02 gamma(00000245)=0.123608691337411E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 245 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000245)=0.000000000000000E+00 beta (00000246)=0.132371067725124E+02 gamma(00000246)=0.132371067725124E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 246 z1= 1 0.228941400684155E-04 0.000000000000000E+00 z1= 2 -.738792327491819E-05 0.000000000000000E+00 z1= 3 0.806964636902836E-03 0.000000000000000E+00 alpha(00000246)=0.000000000000000E+00 beta (00000247)=0.124244279834381E+02 gamma(00000247)=0.124244279834381E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 247 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000247)=0.000000000000000E+00 beta (00000248)=0.131617667928201E+02 gamma(00000248)=0.131617667928201E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 248 z1= 1 -.247318362106883E-04 0.000000000000000E+00 z1= 2 0.372623232407600E-05 0.000000000000000E+00 z1= 3 -.923721733929704E-03 0.000000000000000E+00 alpha(00000248)=0.000000000000000E+00 beta (00000249)=0.128145081964297E+02 gamma(00000249)=0.128145081964297E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 249 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000249)=0.000000000000000E+00 beta (00000250)=0.130181942331427E+02 gamma(00000250)=0.130181942331427E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 250 z1= 1 0.263079008545453E-04 0.000000000000000E+00 z1= 2 -.785151072955513E-05 0.000000000000000E+00 z1= 3 0.146676369201281E-02 0.000000000000000E+00 alpha(00000250)=0.000000000000000E+00 beta (00000251)=0.124728326055674E+02 gamma(00000251)=0.124728326055674E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 251 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000251)=0.000000000000000E+00 beta (00000252)=0.130943473223531E+02 gamma(00000252)=0.130943473223531E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 252 z1= 1 -.286545699942814E-04 0.000000000000000E+00 z1= 2 0.198569818124473E-05 0.000000000000000E+00 z1= 3 -.235866071896420E-02 0.000000000000000E+00 alpha(00000252)=0.000000000000000E+00 beta (00000253)=0.119059635930272E+02 gamma(00000253)=0.119059635930272E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 253 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000253)=0.000000000000000E+00 beta (00000254)=0.132117395255188E+02 gamma(00000254)=0.132117395255188E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 254 z1= 1 0.269305757518599E-04 0.000000000000000E+00 z1= 2 -.667966127595467E-05 0.000000000000000E+00 z1= 3 0.340885026483212E-02 0.000000000000000E+00 alpha(00000254)=0.000000000000000E+00 beta (00000255)=0.124617428035934E+02 gamma(00000255)=0.124617428035934E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 255 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000255)=0.000000000000000E+00 beta (00000256)=0.133423864750766E+02 gamma(00000256)=0.133423864750766E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 256 z1= 1 -.250013235950736E-04 0.000000000000000E+00 z1= 2 -.302976374786420E-05 0.000000000000000E+00 z1= 3 -.450542975024899E-02 0.000000000000000E+00 alpha(00000256)=0.000000000000000E+00 beta (00000257)=0.126899950837603E+02 gamma(00000257)=0.126899950837603E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 257 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000257)=0.000000000000000E+00 beta (00000258)=0.128768510939342E+02 gamma(00000258)=0.128768510939342E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 258 z1= 1 0.229462224062286E-04 0.000000000000000E+00 z1= 2 0.123779567298666E-05 0.000000000000000E+00 z1= 3 0.557062951626958E-02 0.000000000000000E+00 alpha(00000258)=0.000000000000000E+00 beta (00000259)=0.125181738971892E+02 gamma(00000259)=0.125181738971892E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 259 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000259)=0.000000000000000E+00 beta (00000260)=0.131933390910474E+02 gamma(00000260)=0.131933390910474E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 260 z1= 1 -.218659132895216E-04 0.000000000000000E+00 z1= 2 -.922866185006619E-05 0.000000000000000E+00 z1= 3 -.594509639574800E-02 0.000000000000000E+00 alpha(00000260)=0.000000000000000E+00 beta (00000261)=0.122877544929326E+02 gamma(00000261)=0.122877544929326E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 261 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000261)=0.000000000000000E+00 beta (00000262)=0.137474538122384E+02 gamma(00000262)=0.137474538122384E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 262 z1= 1 0.190802041055369E-04 0.000000000000000E+00 z1= 2 0.816028741382094E-05 0.000000000000000E+00 z1= 3 0.530345117712133E-02 0.000000000000000E+00 alpha(00000262)=0.000000000000000E+00 beta (00000263)=0.126746578603852E+02 gamma(00000263)=0.126746578603852E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 263 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000263)=0.000000000000000E+00 beta (00000264)=0.130556845980711E+02 gamma(00000264)=0.130556845980711E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 264 z1= 1 -.160652205948242E-04 0.000000000000000E+00 z1= 2 -.214274616494305E-04 0.000000000000000E+00 z1= 3 -.469960172295525E-02 0.000000000000000E+00 alpha(00000264)=0.000000000000000E+00 beta (00000265)=0.129578023168021E+02 gamma(00000265)=0.129578023168021E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 265 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000265)=0.000000000000000E+00 beta (00000266)=0.133982074692396E+02 gamma(00000266)=0.133982074692396E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 266 z1= 1 0.144837753635734E-04 0.000000000000000E+00 z1= 2 0.215961439412013E-04 0.000000000000000E+00 z1= 3 0.398514196091173E-02 0.000000000000000E+00 alpha(00000266)=0.000000000000000E+00 beta (00000267)=0.124019673134550E+02 gamma(00000267)=0.124019673134550E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 267 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000267)=0.000000000000000E+00 beta (00000268)=0.131860739540629E+02 gamma(00000268)=0.131860739540629E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 268 z1= 1 -.107127074790009E-04 0.000000000000000E+00 z1= 2 -.340480836355493E-04 0.000000000000000E+00 z1= 3 -.341366088537740E-02 0.000000000000000E+00 alpha(00000268)=0.000000000000000E+00 beta (00000269)=0.119898717497070E+02 gamma(00000269)=0.119898717497070E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 269 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000269)=0.000000000000000E+00 beta (00000270)=0.130685992265051E+02 gamma(00000270)=0.130685992265051E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 270 z1= 1 0.112158569395963E-04 0.000000000000000E+00 z1= 2 0.379951301338099E-04 0.000000000000000E+00 z1= 3 0.327444255102728E-02 0.000000000000000E+00 alpha(00000270)=0.000000000000000E+00 beta (00000271)=0.130865092234887E+02 gamma(00000271)=0.130865092234887E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 271 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000271)=0.000000000000000E+00 beta (00000272)=0.134552825515509E+02 gamma(00000272)=0.134552825515509E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 272 z1= 1 -.353542613362430E-05 0.000000000000000E+00 z1= 2 -.488162866072348E-04 0.000000000000000E+00 z1= 3 -.351353421982153E-02 0.000000000000000E+00 alpha(00000272)=0.000000000000000E+00 beta (00000273)=0.125023558024468E+02 gamma(00000273)=0.125023558024468E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 273 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000273)=0.000000000000000E+00 beta (00000274)=0.126454589737379E+02 gamma(00000274)=0.126454589737379E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 274 z1= 1 0.557220849666190E-05 0.000000000000000E+00 z1= 2 0.597742824729119E-04 0.000000000000000E+00 z1= 3 0.395506009460073E-02 0.000000000000000E+00 alpha(00000274)=0.000000000000000E+00 beta (00000275)=0.127293917069661E+02 gamma(00000275)=0.127293917069661E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 275 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000275)=0.000000000000000E+00 beta (00000276)=0.131718788718115E+02 gamma(00000276)=0.131718788718115E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 276 z1= 1 0.239898440446682E-05 0.000000000000000E+00 z1= 2 -.601110774741737E-04 0.000000000000000E+00 z1= 3 -.432079321870497E-02 0.000000000000000E+00 alpha(00000276)=0.000000000000000E+00 beta (00000277)=0.131556540498597E+02 gamma(00000277)=0.131556540498597E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 277 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000277)=0.000000000000000E+00 beta (00000278)=0.130685098340526E+02 gamma(00000278)=0.130685098340526E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 278 z1= 1 0.521584961847858E-05 0.000000000000000E+00 z1= 2 0.714694428857302E-04 0.000000000000000E+00 z1= 3 0.474286923026408E-02 0.000000000000000E+00 alpha(00000278)=0.000000000000000E+00 beta (00000279)=0.126461020182858E+02 gamma(00000279)=0.126461020182858E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 279 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000279)=0.000000000000000E+00 beta (00000280)=0.135250790588302E+02 gamma(00000280)=0.135250790588302E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 280 z1= 1 0.763087746027827E-05 0.000000000000000E+00 z1= 2 -.685644507028750E-04 0.000000000000000E+00 z1= 3 -.503746320028028E-02 0.000000000000000E+00 alpha(00000280)=0.000000000000000E+00 beta (00000281)=0.126346877983881E+02 gamma(00000281)=0.126346877983881E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 281 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000281)=0.000000000000000E+00 beta (00000282)=0.132703258820964E+02 gamma(00000282)=0.132703258820964E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 282 z1= 1 -.161842126618166E-05 0.000000000000000E+00 z1= 2 0.786855349205877E-04 0.000000000000000E+00 z1= 3 0.574738871934735E-02 0.000000000000000E+00 alpha(00000282)=0.000000000000000E+00 beta (00000283)=0.121732084850808E+02 gamma(00000283)=0.121732084850808E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 283 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000283)=0.000000000000000E+00 beta (00000284)=0.135196969991775E+02 gamma(00000284)=0.135196969991775E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 284 z1= 1 0.862793391621561E-05 0.000000000000000E+00 z1= 2 -.714763530858725E-04 0.000000000000000E+00 z1= 3 -.631172382771435E-02 0.000000000000000E+00 alpha(00000284)=0.000000000000000E+00 beta (00000285)=0.126723632996961E+02 gamma(00000285)=0.126723632996961E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 285 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000285)=0.000000000000000E+00 beta (00000286)=0.134130138117516E+02 gamma(00000286)=0.134130138117516E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 286 z1= 1 -.848361108766712E-06 0.000000000000000E+00 z1= 2 0.731970596024241E-04 0.000000000000000E+00 z1= 3 0.707003029818083E-02 0.000000000000000E+00 alpha(00000286)=0.000000000000000E+00 beta (00000287)=0.121004767492052E+02 gamma(00000287)=0.121004767492052E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 287 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000287)=0.000000000000000E+00 beta (00000288)=0.134075541640510E+02 gamma(00000288)=0.134075541640510E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 288 z1= 1 0.362367517632058E-05 0.000000000000000E+00 z1= 2 -.678392083820872E-04 0.000000000000000E+00 z1= 3 -.717854981920080E-02 0.000000000000000E+00 alpha(00000288)=0.000000000000000E+00 beta (00000289)=0.124516415463018E+02 gamma(00000289)=0.124516415463018E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 289 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000289)=0.000000000000000E+00 beta (00000290)=0.134116426163703E+02 gamma(00000290)=0.134116426163703E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 290 z1= 1 0.363981746713256E-05 0.000000000000000E+00 z1= 2 0.711603325830555E-04 0.000000000000000E+00 z1= 3 0.745717078209564E-02 0.000000000000000E+00 alpha(00000290)=0.000000000000000E+00 beta (00000291)=0.127580227958731E+02 gamma(00000291)=0.127580227958731E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 291 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000291)=0.000000000000000E+00 beta (00000292)=0.130392295189705E+02 gamma(00000292)=0.130392295189705E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 292 z1= 1 -.338877454214429E-05 0.000000000000000E+00 z1= 2 -.703399468867629E-04 0.000000000000000E+00 z1= 3 -.800646827525997E-02 0.000000000000000E+00 alpha(00000292)=0.000000000000000E+00 beta (00000293)=0.130402015468324E+02 gamma(00000293)=0.130402015468324E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 293 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000293)=0.000000000000000E+00 beta (00000294)=0.134240793394835E+02 gamma(00000294)=0.134240793394835E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 294 z1= 1 0.105850875878625E-04 0.000000000000000E+00 z1= 2 0.732531490688599E-04 0.000000000000000E+00 z1= 3 0.835345340383887E-02 0.000000000000000E+00 alpha(00000294)=0.000000000000000E+00 beta (00000295)=0.123564848059914E+02 gamma(00000295)=0.123564848059914E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 295 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000295)=0.000000000000000E+00 beta (00000296)=0.136450368302295E+02 gamma(00000296)=0.136450368302295E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 296 z1= 1 -.159561788559294E-04 0.000000000000000E+00 z1= 2 -.658503303505042E-04 0.000000000000000E+00 z1= 3 -.823090016796556E-02 0.000000000000000E+00 alpha(00000296)=0.000000000000000E+00 beta (00000297)=0.124622758361245E+02 gamma(00000297)=0.124622758361245E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 297 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000297)=0.000000000000000E+00 beta (00000298)=0.133260105315576E+02 gamma(00000298)=0.133260105315576E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 298 z1= 1 0.178904340555445E-04 0.000000000000000E+00 z1= 2 0.643976801363121E-04 0.000000000000000E+00 z1= 3 0.846195655547659E-02 0.000000000000000E+00 alpha(00000298)=0.000000000000000E+00 beta (00000299)=0.125338331027753E+02 gamma(00000299)=0.125338331027753E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 299 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000299)=0.000000000000000E+00 beta (00000300)=0.131094755014985E+02 gamma(00000300)=0.131094755014985E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 300 z1= 1 -.219082087705585E-04 0.000000000000000E+00 z1= 2 -.716612518850126E-04 0.000000000000000E+00 z1= 3 -.878149311531204E-02 0.000000000000000E+00 alpha(00000300)=0.000000000000000E+00 beta (00000301)=0.122927520886163E+02 gamma(00000301)=0.122927520886163E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 301 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000301)=0.000000000000000E+00 beta (00000302)=0.128684886085662E+02 gamma(00000302)=0.128684886085662E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 302 z1= 1 0.208932815315260E-04 0.000000000000000E+00 z1= 2 0.727668398531745E-04 0.000000000000000E+00 z1= 3 0.902007743572321E-02 0.000000000000000E+00 alpha(00000302)=0.000000000000000E+00 beta (00000303)=0.128438348815580E+02 gamma(00000303)=0.128438348815580E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 303 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000303)=0.000000000000000E+00 beta (00000304)=0.134652610985756E+02 gamma(00000304)=0.134652610985756E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 304 z1= 1 -.285699602028417E-04 0.000000000000000E+00 z1= 2 -.786288507718087E-04 0.000000000000000E+00 z1= 3 -.923347452206692E-02 0.000000000000000E+00 alpha(00000304)=0.000000000000000E+00 beta (00000305)=0.129096140061455E+02 gamma(00000305)=0.129096140061455E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 305 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000305)=0.000000000000000E+00 beta (00000306)=0.134085991370022E+02 gamma(00000306)=0.134085991370022E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 306 z1= 1 0.274764826363713E-04 0.000000000000000E+00 z1= 2 0.753631474425036E-04 0.000000000000000E+00 z1= 3 0.957561373135303E-02 0.000000000000000E+00 alpha(00000306)=0.000000000000000E+00 beta (00000307)=0.123362638299031E+02 gamma(00000307)=0.123362638299031E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 307 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000307)=0.000000000000000E+00 beta (00000308)=0.134925219648533E+02 gamma(00000308)=0.134925219648533E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 308 z1= 1 -.321754086845952E-04 0.000000000000000E+00 z1= 2 -.781148988209452E-04 0.000000000000000E+00 z1= 3 -.929869059025373E-02 0.000000000000000E+00 alpha(00000308)=0.000000000000000E+00 beta (00000309)=0.124610447881652E+02 gamma(00000309)=0.124610447881652E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 309 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000309)=0.000000000000000E+00 beta (00000310)=0.130638356426122E+02 gamma(00000310)=0.130638356426122E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 310 z1= 1 0.235376212016248E-04 0.000000000000000E+00 z1= 2 0.800429091499878E-04 0.000000000000000E+00 z1= 3 0.947352108923104E-02 0.000000000000000E+00 alpha(00000310)=0.000000000000000E+00 beta (00000311)=0.128417227614321E+02 gamma(00000311)=0.128417227614321E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 311 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000311)=0.000000000000000E+00 beta (00000312)=0.133511320295012E+02 gamma(00000312)=0.133511320295012E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 312 z1= 1 -.253285325712741E-04 0.000000000000000E+00 z1= 2 -.824915349660416E-04 0.000000000000000E+00 z1= 3 -.959629359885855E-02 0.000000000000000E+00 alpha(00000312)=0.000000000000000E+00 beta (00000313)=0.123310498242121E+02 gamma(00000313)=0.123310498242121E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 313 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000313)=0.000000000000000E+00 beta (00000314)=0.126433294470817E+02 gamma(00000314)=0.126433294470817E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 314 z1= 1 0.207642645628837E-04 0.000000000000000E+00 z1= 2 0.860108247204319E-04 0.000000000000000E+00 z1= 3 0.949330039179291E-02 0.000000000000000E+00 alpha(00000314)=0.000000000000000E+00 beta (00000315)=0.123994739948092E+02 gamma(00000315)=0.123994739948092E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 315 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000315)=0.000000000000000E+00 beta (00000316)=0.129779663292780E+02 gamma(00000316)=0.129779663292780E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 316 z1= 1 -.188496168107791E-04 0.000000000000000E+00 z1= 2 -.847066149788663E-04 0.000000000000000E+00 z1= 3 -.880043989290399E-02 0.000000000000000E+00 alpha(00000316)=0.000000000000000E+00 beta (00000317)=0.128915994728819E+02 gamma(00000317)=0.128915994728819E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 317 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000317)=0.000000000000000E+00 beta (00000318)=0.135270833779653E+02 gamma(00000318)=0.135270833779653E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 318 z1= 1 0.137600274404250E-04 0.000000000000000E+00 z1= 2 0.837139597739792E-04 0.000000000000000E+00 z1= 3 0.814027055698321E-02 0.000000000000000E+00 alpha(00000318)=0.000000000000000E+00 beta (00000319)=0.129222328086046E+02 gamma(00000319)=0.129222328086046E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 319 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000319)=0.000000000000000E+00 beta (00000320)=0.131260298188288E+02 gamma(00000320)=0.131260298188288E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 320 z1= 1 -.108683182054436E-04 0.000000000000000E+00 z1= 2 -.825594901826970E-04 0.000000000000000E+00 z1= 3 -.807974347456248E-02 0.000000000000000E+00 alpha(00000320)=0.000000000000000E+00 beta (00000321)=0.121862279293431E+02 gamma(00000321)=0.121862279293431E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 321 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000321)=0.000000000000000E+00 beta (00000322)=0.131582416911947E+02 gamma(00000322)=0.131582416911947E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 322 z1= 1 0.813971444846364E-05 0.000000000000000E+00 z1= 2 0.800633587095363E-04 0.000000000000000E+00 z1= 3 0.770301442827362E-02 0.000000000000000E+00 alpha(00000322)=0.000000000000000E+00 beta (00000323)=0.129428254877175E+02 gamma(00000323)=0.129428254877175E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 323 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000323)=0.000000000000000E+00 beta (00000324)=0.134069503118754E+02 gamma(00000324)=0.134069503118754E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 324 z1= 1 -.550311147731237E-05 0.000000000000000E+00 z1= 2 -.750506441545360E-04 0.000000000000000E+00 z1= 3 -.769490135022748E-02 0.000000000000000E+00 alpha(00000324)=0.000000000000000E+00 beta (00000325)=0.124358239534428E+02 gamma(00000325)=0.124358239534428E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 325 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000325)=0.000000000000000E+00 beta (00000326)=0.137497438070782E+02 gamma(00000326)=0.137497438070782E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 326 z1= 1 0.559191432465437E-05 0.000000000000000E+00 z1= 2 0.744601674689535E-04 0.000000000000000E+00 z1= 3 0.744721964678720E-02 0.000000000000000E+00 alpha(00000326)=0.000000000000000E+00 beta (00000327)=0.125929819521267E+02 gamma(00000327)=0.125929819521267E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 327 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000327)=0.000000000000000E+00 beta (00000328)=0.134348085539051E+02 gamma(00000328)=0.134348085539051E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 328 z1= 1 0.443853468050988E-05 0.000000000000000E+00 z1= 2 -.694462523866142E-04 0.000000000000000E+00 z1= 3 -.765532892183640E-02 0.000000000000000E+00 alpha(00000328)=0.000000000000000E+00 beta (00000329)=0.123254330856984E+02 gamma(00000329)=0.123254330856984E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 329 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000329)=0.000000000000000E+00 beta (00000330)=0.134395235482498E+02 gamma(00000330)=0.134395235482498E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 330 z1= 1 -.866113874689274E-05 0.000000000000000E+00 z1= 2 0.747845839630564E-04 0.000000000000000E+00 z1= 3 0.767395904726395E-02 0.000000000000000E+00 alpha(00000330)=0.000000000000000E+00 beta (00000331)=0.127449141869205E+02 gamma(00000331)=0.127449141869205E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 331 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000331)=0.000000000000000E+00 beta (00000332)=0.134806624789147E+02 gamma(00000332)=0.134806624789147E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 332 z1= 1 0.100454407349205E-04 0.000000000000000E+00 z1= 2 -.785591257116467E-04 0.000000000000000E+00 z1= 3 -.790218282405119E-02 0.000000000000000E+00 alpha(00000332)=0.000000000000000E+00 beta (00000333)=0.123455412104762E+02 gamma(00000333)=0.123455412104762E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 333 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000333)=0.000000000000000E+00 beta (00000334)=0.131083926766411E+02 gamma(00000334)=0.131083926766411E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 334 z1= 1 -.152619821941930E-04 0.000000000000000E+00 z1= 2 0.821956791974757E-04 0.000000000000000E+00 z1= 3 0.768506582634760E-02 0.000000000000000E+00 alpha(00000334)=0.000000000000000E+00 beta (00000335)=0.126397510906185E+02 gamma(00000335)=0.126397510906185E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 335 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000335)=0.000000000000000E+00 beta (00000336)=0.129359586106242E+02 gamma(00000336)=0.129359586106242E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 336 z1= 1 0.168625000252755E-04 0.000000000000000E+00 z1= 2 -.935798044579273E-04 0.000000000000000E+00 z1= 3 -.729033746304011E-02 0.000000000000000E+00 alpha(00000336)=0.000000000000000E+00 beta (00000337)=0.122706277528074E+02 gamma(00000337)=0.122706277528074E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 337 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000337)=0.000000000000000E+00 beta (00000338)=0.128997126837328E+02 gamma(00000338)=0.128997126837328E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 338 z1= 1 -.221631261254101E-04 0.000000000000000E+00 z1= 2 0.975975700654996E-04 0.000000000000000E+00 z1= 3 0.652326788252961E-02 0.000000000000000E+00 alpha(00000338)=0.000000000000000E+00 beta (00000339)=0.123795961547307E+02 gamma(00000339)=0.123795961547307E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 339 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000339)=0.000000000000000E+00 beta (00000340)=0.134086552544794E+02 gamma(00000340)=0.134086552544794E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 340 z1= 1 0.201647246530624E-04 0.000000000000000E+00 z1= 2 -.107505906225287E-03 0.000000000000000E+00 z1= 3 -.561061748037791E-02 0.000000000000000E+00 alpha(00000340)=0.000000000000000E+00 beta (00000341)=0.124427311534669E+02 gamma(00000341)=0.124427311534669E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 341 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000341)=0.000000000000000E+00 beta (00000342)=0.134336601159084E+02 gamma(00000342)=0.134336601159084E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 342 z1= 1 -.280968122188234E-04 0.000000000000000E+00 z1= 2 0.107001132471420E-03 0.000000000000000E+00 z1= 3 0.482162444372513E-02 0.000000000000000E+00 alpha(00000342)=0.000000000000000E+00 beta (00000343)=0.128949058451797E+02 gamma(00000343)=0.128949058451797E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 343 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000343)=0.000000000000000E+00 beta (00000344)=0.131869586238282E+02 gamma(00000344)=0.131869586238282E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 344 z1= 1 0.250485615732474E-04 0.000000000000000E+00 z1= 2 -.124107410023783E-03 0.000000000000000E+00 z1= 3 -.434016019669520E-02 0.000000000000000E+00 alpha(00000344)=0.000000000000000E+00 beta (00000345)=0.121256411028852E+02 gamma(00000345)=0.121256411028852E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 345 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000345)=0.000000000000000E+00 beta (00000346)=0.130233900201902E+02 gamma(00000346)=0.130233900201902E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 346 z1= 1 -.280279671539974E-04 0.000000000000000E+00 z1= 2 0.117698599919291E-03 0.000000000000000E+00 z1= 3 0.381302339776922E-02 0.000000000000000E+00 alpha(00000346)=0.000000000000000E+00 beta (00000347)=0.130673266645484E+02 gamma(00000347)=0.130673266645484E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 347 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000347)=0.000000000000000E+00 beta (00000348)=0.137436387258521E+02 gamma(00000348)=0.137436387258521E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 348 z1= 1 0.181978893497382E-04 0.000000000000000E+00 z1= 2 -.128470092678916E-03 0.000000000000000E+00 z1= 3 -.368947897143929E-02 0.000000000000000E+00 alpha(00000348)=0.000000000000000E+00 beta (00000349)=0.126921243609696E+02 gamma(00000349)=0.126921243609696E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 349 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000349)=0.000000000000000E+00 beta (00000350)=0.130730176671590E+02 gamma(00000350)=0.130730176671590E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 350 z1= 1 -.253183283036932E-04 0.000000000000000E+00 z1= 2 0.126043521105980E-03 0.000000000000000E+00 z1= 3 0.370346448535039E-02 0.000000000000000E+00 alpha(00000350)=0.000000000000000E+00 beta (00000351)=0.125205601197259E+02 gamma(00000351)=0.125205601197259E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 351 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000351)=0.000000000000000E+00 beta (00000352)=0.135686466655043E+02 gamma(00000352)=0.135686466655043E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 352 z1= 1 0.160645468875750E-04 0.000000000000000E+00 z1= 2 -.133207730542842E-03 0.000000000000000E+00 z1= 3 -.359873017385838E-02 0.000000000000000E+00 alpha(00000352)=0.000000000000000E+00 beta (00000353)=0.127353770809447E+02 gamma(00000353)=0.127353770809447E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 353 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000353)=0.000000000000000E+00 beta (00000354)=0.134285605431254E+02 gamma(00000354)=0.134285605431254E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 354 z1= 1 -.174958408120178E-04 0.000000000000000E+00 z1= 2 0.129227165272818E-03 0.000000000000000E+00 z1= 3 0.378736720297647E-02 0.000000000000000E+00 alpha(00000354)=0.000000000000000E+00 beta (00000355)=0.126773221573971E+02 gamma(00000355)=0.126773221573971E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 355 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000355)=0.000000000000000E+00 beta (00000356)=0.134947939862715E+02 gamma(00000356)=0.134947939862715E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 356 z1= 1 0.147113738382417E-04 0.000000000000000E+00 z1= 2 -.134006534206963E-03 0.000000000000000E+00 z1= 3 -.387510512479052E-02 0.000000000000000E+00 alpha(00000356)=0.000000000000000E+00 beta (00000357)=0.125498552622712E+02 gamma(00000357)=0.125498552622712E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 357 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000357)=0.000000000000000E+00 beta (00000358)=0.129960076220937E+02 gamma(00000358)=0.129960076220937E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 358 z1= 1 -.105887501536869E-04 0.000000000000000E+00 z1= 2 0.136329014975188E-03 0.000000000000000E+00 z1= 3 0.403222781908254E-02 0.000000000000000E+00 alpha(00000358)=0.000000000000000E+00 beta (00000359)=0.124990563053134E+02 gamma(00000359)=0.124990563053134E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 359 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000359)=0.000000000000000E+00 beta (00000360)=0.138144650261026E+02 gamma(00000360)=0.138144650261026E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 360 z1= 1 0.101550538035038E-04 0.000000000000000E+00 z1= 2 -.129641759459637E-03 0.000000000000000E+00 z1= 3 -.389409014888060E-02 0.000000000000000E+00 alpha(00000360)=0.000000000000000E+00 beta (00000361)=0.124245152283880E+02 gamma(00000361)=0.124245152283880E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 361 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000361)=0.000000000000000E+00 beta (00000362)=0.127983330319765E+02 gamma(00000362)=0.127983330319765E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 362 z1= 1 -.566502910653296E-05 0.000000000000000E+00 z1= 2 0.141005556180240E-03 0.000000000000000E+00 z1= 3 0.381959810912989E-02 0.000000000000000E+00 alpha(00000362)=0.000000000000000E+00 beta (00000363)=0.120816201902094E+02 gamma(00000363)=0.120816201902094E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 363 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000363)=0.000000000000000E+00 beta (00000364)=0.134745494390955E+02 gamma(00000364)=0.134745494390955E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 364 z1= 1 0.796282118649595E-05 0.000000000000000E+00 z1= 2 -.129601863474666E-03 0.000000000000000E+00 z1= 3 -.311034404304881E-02 0.000000000000000E+00 alpha(00000364)=0.000000000000000E+00 beta (00000365)=0.125471941982166E+02 gamma(00000365)=0.125471941982166E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 365 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000365)=0.000000000000000E+00 beta (00000366)=0.133064803207854E+02 gamma(00000366)=0.133064803207854E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 366 z1= 1 0.349242263499055E-05 0.000000000000000E+00 z1= 2 0.145877304488336E-03 0.000000000000000E+00 z1= 3 0.265371823222755E-02 0.000000000000000E+00 alpha(00000366)=0.000000000000000E+00 beta (00000367)=0.127274909432651E+02 gamma(00000367)=0.127274909432651E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 367 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000367)=0.000000000000000E+00 beta (00000368)=0.128654985377456E+02 gamma(00000368)=0.128654985377456E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 368 z1= 1 0.634293791626972E-05 0.000000000000000E+00 z1= 2 -.146377005564172E-03 0.000000000000000E+00 z1= 3 -.264844618578195E-02 0.000000000000000E+00 alpha(00000368)=0.000000000000000E+00 beta (00000369)=0.123636315530549E+02 gamma(00000369)=0.123636315530549E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 369 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000369)=0.000000000000000E+00 beta (00000370)=0.135713078973711E+02 gamma(00000370)=0.135713078973711E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 370 z1= 1 0.943564575658034E-05 0.000000000000000E+00 z1= 2 0.163435097678547E-03 0.000000000000000E+00 z1= 3 0.257455954614819E-02 0.000000000000000E+00 alpha(00000370)=0.000000000000000E+00 beta (00000371)=0.128520809266438E+02 gamma(00000371)=0.128520809266438E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 371 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000371)=0.000000000000000E+00 beta (00000372)=0.131005914807217E+02 gamma(00000372)=0.131005914807217E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 372 z1= 1 0.387812310993400E-05 0.000000000000000E+00 z1= 2 -.163975917766359E-03 0.000000000000000E+00 z1= 3 -.273453156490949E-02 0.000000000000000E+00 alpha(00000372)=0.000000000000000E+00 beta (00000373)=0.120200800341629E+02 gamma(00000373)=0.120200800341629E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 373 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000373)=0.000000000000000E+00 beta (00000374)=0.131404655474091E+02 gamma(00000374)=0.131404655474091E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 374 z1= 1 0.131993119454635E-04 0.000000000000000E+00 z1= 2 0.183389046468265E-03 0.000000000000000E+00 z1= 3 0.266715788507557E-02 0.000000000000000E+00 alpha(00000374)=0.000000000000000E+00 beta (00000375)=0.132572294134535E+02 gamma(00000375)=0.132572294134535E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 375 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000375)=0.000000000000000E+00 beta (00000376)=0.128740475288656E+02 gamma(00000376)=0.128740475288656E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 376 z1= 1 0.162079372646999E-05 0.000000000000000E+00 z1= 2 -.186273682844423E-03 0.000000000000000E+00 z1= 3 -.280907891907223E-02 0.000000000000000E+00 alpha(00000376)=0.000000000000000E+00 beta (00000377)=0.123376995497939E+02 gamma(00000377)=0.123376995497939E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 377 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000377)=0.000000000000000E+00 beta (00000378)=0.134171499242572E+02 gamma(00000378)=0.134171499242572E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 378 z1= 1 0.186398946588013E-04 0.000000000000000E+00 z1= 2 0.202060419452682E-03 0.000000000000000E+00 z1= 3 0.267050604114297E-02 0.000000000000000E+00 alpha(00000378)=0.000000000000000E+00 beta (00000379)=0.125813276849825E+02 gamma(00000379)=0.125813276849825E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 379 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000379)=0.000000000000000E+00 beta (00000380)=0.131266657526136E+02 gamma(00000380)=0.131266657526136E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 380 z1= 1 -.128649370604900E-05 0.000000000000000E+00 z1= 2 -.194128045696719E-03 0.000000000000000E+00 z1= 3 -.274894728693759E-02 0.000000000000000E+00 alpha(00000380)=0.000000000000000E+00 beta (00000381)=0.124970686503952E+02 gamma(00000381)=0.124970686503952E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 381 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000381)=0.000000000000000E+00 beta (00000382)=0.133542398204165E+02 gamma(00000382)=0.133542398204165E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 382 z1= 1 0.207509078195794E-04 0.000000000000000E+00 z1= 2 0.207367593648300E-03 0.000000000000000E+00 z1= 3 0.281884381363109E-02 0.000000000000000E+00 alpha(00000382)=0.000000000000000E+00 beta (00000383)=0.126664992178921E+02 gamma(00000383)=0.126664992178921E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 383 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000383)=0.000000000000000E+00 beta (00000384)=0.129172916109177E+02 gamma(00000384)=0.129172916109177E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 384 z1= 1 0.275024688548069E-05 0.000000000000000E+00 z1= 2 -.201806915627727E-03 0.000000000000000E+00 z1= 3 -.319542798498026E-02 0.000000000000000E+00 alpha(00000384)=0.000000000000000E+00 beta (00000385)=0.124533708742034E+02 gamma(00000385)=0.124533708742034E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 385 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000385)=0.000000000000000E+00 beta (00000386)=0.125974544088970E+02 gamma(00000386)=0.125974544088970E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 386 z1= 1 0.186966600057982E-04 0.000000000000000E+00 z1= 2 0.227570694151757E-03 0.000000000000000E+00 z1= 3 0.366793924255541E-02 0.000000000000000E+00 alpha(00000386)=0.000000000000000E+00 beta (00000387)=0.126742619861103E+02 gamma(00000387)=0.126742619861103E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 387 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000387)=0.000000000000000E+00 beta (00000388)=0.131977590935884E+02 gamma(00000388)=0.131977590935884E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 388 z1= 1 0.123167068672964E-04 0.000000000000000E+00 z1= 2 -.209314033332173E-03 0.000000000000000E+00 z1= 3 -.407817573613336E-02 0.000000000000000E+00 alpha(00000388)=0.000000000000000E+00 beta (00000389)=0.128138155383715E+02 gamma(00000389)=0.128138155383715E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 389 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000389)=0.000000000000000E+00 beta (00000390)=0.135325284929003E+02 gamma(00000390)=0.135325284929003E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 390 z1= 1 0.159501204329537E-04 0.000000000000000E+00 z1= 2 0.230397483457215E-03 0.000000000000000E+00 z1= 3 0.457077451012222E-02 0.000000000000000E+00 alpha(00000390)=0.000000000000000E+00 beta (00000391)=0.127727161819768E+02 gamma(00000391)=0.127727161819768E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 391 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000391)=0.000000000000000E+00 beta (00000392)=0.134217173599066E+02 gamma(00000392)=0.134217173599066E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 392 z1= 1 0.266222148128332E-04 0.000000000000000E+00 z1= 2 -.204466313025329E-03 0.000000000000000E+00 z1= 3 -.504021850229601E-02 0.000000000000000E+00 alpha(00000392)=0.000000000000000E+00 beta (00000393)=0.127287898528659E+02 gamma(00000393)=0.127287898528659E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 393 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000393)=0.000000000000000E+00 beta (00000394)=0.127725637450430E+02 gamma(00000394)=0.127725637450430E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 394 z1= 1 0.649186538056068E-05 0.000000000000000E+00 z1= 2 0.244131291437282E-03 0.000000000000000E+00 z1= 3 0.564815411243183E-02 0.000000000000000E+00 alpha(00000394)=0.000000000000000E+00 beta (00000395)=0.127745103648320E+02 gamma(00000395)=0.127745103648320E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 395 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000395)=0.000000000000000E+00 beta (00000396)=0.133831779759978E+02 gamma(00000396)=0.133831779759978E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 396 z1= 1 0.348628361192763E-04 0.000000000000000E+00 z1= 2 -.220723014774695E-03 0.000000000000000E+00 z1= 3 -.602772138558057E-02 0.000000000000000E+00 alpha(00000396)=0.000000000000000E+00 beta (00000397)=0.124007798403747E+02 gamma(00000397)=0.124007798403747E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 397 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000397)=0.000000000000000E+00 beta (00000398)=0.129240059782609E+02 gamma(00000398)=0.129240059782609E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 398 z1= 1 -.357573585775474E-05 0.000000000000000E+00 z1= 2 0.257140188035897E-03 0.000000000000000E+00 z1= 3 0.647206299864745E-02 0.000000000000000E+00 alpha(00000398)=0.000000000000000E+00 beta (00000399)=0.124237263922235E+02 gamma(00000399)=0.124237263922235E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 399 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000399)=0.000000000000000E+00 beta (00000400)=0.139569417142003E+02 gamma(00000400)=0.139569417142003E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 400 z1= 1 0.465880232610160E-04 0.000000000000000E+00 z1= 2 -.202257822253586E-03 0.000000000000000E+00 z1= 3 -.657603222567491E-02 0.000000000000000E+00 alpha(00000400)=0.000000000000000E+00 beta (00000401)=0.126214305893942E+02 gamma(00000401)=0.126214305893942E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 401 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000401)=0.000000000000000E+00 beta (00000402)=0.132783282207437E+02 gamma(00000402)=0.132783282207437E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 402 z1= 1 0.213415981406095E-05 0.000000000000000E+00 z1= 2 0.238507102172018E-03 0.000000000000000E+00 z1= 3 0.719423091097345E-02 0.000000000000000E+00 alpha(00000402)=0.000000000000000E+00 beta (00000403)=0.124765712198290E+02 gamma(00000403)=0.124765712198290E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 403 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000403)=0.000000000000000E+00 beta (00000404)=0.130893798749312E+02 gamma(00000404)=0.130893798749312E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 404 z1= 1 0.473973055350411E-04 0.000000000000000E+00 z1= 2 -.201802251162088E-03 0.000000000000000E+00 z1= 3 -.785302968977705E-02 0.000000000000000E+00 alpha(00000404)=0.000000000000000E+00 beta (00000405)=0.130452970626816E+02 gamma(00000405)=0.130452970626816E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 405 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000405)=0.000000000000000E+00 beta (00000406)=0.131864479196274E+02 gamma(00000406)=0.131864479196274E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 406 z1= 1 0.949734956821402E-06 0.000000000000000E+00 z1= 2 0.251367210269492E-03 0.000000000000000E+00 z1= 3 0.844834565128282E-02 0.000000000000000E+00 alpha(00000406)=0.000000000000000E+00 beta (00000407)=0.126586454408676E+02 gamma(00000407)=0.126586454408676E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 407 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000407)=0.000000000000000E+00 beta (00000408)=0.126006091403783E+02 gamma(00000408)=0.126006091403783E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 408 z1= 1 0.447851076028023E-04 0.000000000000000E+00 z1= 2 -.224641029587387E-03 0.000000000000000E+00 z1= 3 -.883612671770230E-02 0.000000000000000E+00 alpha(00000408)=0.000000000000000E+00 beta (00000409)=0.125410194051080E+02 gamma(00000409)=0.125410194051080E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 409 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000409)=0.000000000000000E+00 beta (00000410)=0.135683037214320E+02 gamma(00000410)=0.135683037214320E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 410 z1= 1 0.707539525639093E-05 0.000000000000000E+00 z1= 2 0.258951337558483E-03 0.000000000000000E+00 z1= 3 0.811838238521704E-02 0.000000000000000E+00 alpha(00000410)=0.000000000000000E+00 beta (00000411)=0.124969969397855E+02 gamma(00000411)=0.124969969397855E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 411 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000411)=0.000000000000000E+00 beta (00000412)=0.134195724394368E+02 gamma(00000412)=0.134195724394368E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 412 z1= 1 0.446585684558771E-04 0.000000000000000E+00 z1= 2 -.197478906158844E-03 0.000000000000000E+00 z1= 3 -.725080691245549E-02 0.000000000000000E+00 alpha(00000412)=0.000000000000000E+00 beta (00000413)=0.128382049589693E+02 gamma(00000413)=0.128382049589693E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 413 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000413)=0.000000000000000E+00 beta (00000414)=0.132550688067027E+02 gamma(00000414)=0.132550688067027E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 414 z1= 1 0.100925368695458E-04 0.000000000000000E+00 z1= 2 0.250628594950279E-03 0.000000000000000E+00 z1= 3 0.659137126874537E-02 0.000000000000000E+00 alpha(00000414)=0.000000000000000E+00 beta (00000415)=0.126868698958828E+02 gamma(00000415)=0.126868698958828E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 415 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000415)=0.000000000000000E+00 beta (00000416)=0.137408651374858E+02 gamma(00000416)=0.137408651374858E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 416 z1= 1 0.387780853941822E-04 0.000000000000000E+00 z1= 2 -.191222608465584E-03 0.000000000000000E+00 z1= 3 -.592943000128972E-02 0.000000000000000E+00 alpha(00000416)=0.000000000000000E+00 beta (00000417)=0.126322430802350E+02 gamma(00000417)=0.126322430802350E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 417 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000417)=0.000000000000000E+00 beta (00000418)=0.124553218608551E+02 gamma(00000418)=0.124553218608551E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 418 z1= 1 -.147297542908091E-05 0.000000000000000E+00 z1= 2 0.240867645575871E-03 0.000000000000000E+00 z1= 3 0.621585823770188E-02 0.000000000000000E+00 alpha(00000418)=0.000000000000000E+00 beta (00000419)=0.128604445909036E+02 gamma(00000419)=0.128604445909036E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 419 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000419)=0.000000000000000E+00 beta (00000420)=0.135315921656453E+02 gamma(00000420)=0.135315921656453E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 420 z1= 1 0.303306527120476E-04 0.000000000000000E+00 z1= 2 -.199317322433846E-03 0.000000000000000E+00 z1= 3 -.629275285742373E-02 0.000000000000000E+00 alpha(00000420)=0.000000000000000E+00 beta (00000421)=0.126912414386958E+02 gamma(00000421)=0.126912414386958E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 421 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000421)=0.000000000000000E+00 beta (00000422)=0.132363024219808E+02 gamma(00000422)=0.132363024219808E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 422 z1= 1 -.518927268425068E-05 0.000000000000000E+00 z1= 2 0.217303690655099E-03 0.000000000000000E+00 z1= 3 0.677822806548650E-02 0.000000000000000E+00 alpha(00000422)=0.000000000000000E+00 beta (00000423)=0.124796096568389E+02 gamma(00000423)=0.124796096568389E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 423 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000423)=0.000000000000000E+00 beta (00000424)=0.131627842019047E+02 gamma(00000424)=0.131627842019047E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 424 z1= 1 0.183722585969501E-04 0.000000000000000E+00 z1= 2 -.191867046471308E-03 0.000000000000000E+00 z1= 3 -.748765012157156E-02 0.000000000000000E+00 alpha(00000424)=0.000000000000000E+00 beta (00000425)=0.123762073053357E+02 gamma(00000425)=0.123762073053357E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 425 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000425)=0.000000000000000E+00 beta (00000426)=0.131118314550812E+02 gamma(00000426)=0.131118314550812E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 426 z1= 1 -.852978743487735E-05 0.000000000000000E+00 z1= 2 0.187891196056074E-03 0.000000000000000E+00 z1= 3 0.790503527608829E-02 0.000000000000000E+00 alpha(00000426)=0.000000000000000E+00 beta (00000427)=0.120878053301252E+02 gamma(00000427)=0.120878053301252E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 427 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000427)=0.000000000000000E+00 beta (00000428)=0.130257221316053E+02 gamma(00000428)=0.130257221316053E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 428 z1= 1 0.209652145484522E-05 0.000000000000000E+00 z1= 2 -.185788483783720E-03 0.000000000000000E+00 z1= 3 -.774971679610717E-02 0.000000000000000E+00 alpha(00000428)=0.000000000000000E+00 beta (00000429)=0.128547239142718E+02 gamma(00000429)=0.128547239142718E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 429 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000429)=0.000000000000000E+00 beta (00000430)=0.130598116917399E+02 gamma(00000430)=0.130598116917399E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 430 z1= 1 -.132366390524085E-04 0.000000000000000E+00 z1= 2 0.163142426108929E-03 0.000000000000000E+00 z1= 3 0.764626079600242E-02 0.000000000000000E+00 alpha(00000430)=0.000000000000000E+00 beta (00000431)=0.123538051984144E+02 gamma(00000431)=0.123538051984144E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 431 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000431)=0.000000000000000E+00 beta (00000432)=0.129332492284681E+02 gamma(00000432)=0.129332492284681E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 432 z1= 1 -.724216871885369E-05 0.000000000000000E+00 z1= 2 -.189248259193146E-03 0.000000000000000E+00 z1= 3 -.687801138330182E-02 0.000000000000000E+00 alpha(00000432)=0.000000000000000E+00 beta (00000433)=0.121355121515695E+02 gamma(00000433)=0.121355121515695E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 433 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000433)=0.000000000000000E+00 beta (00000434)=0.134576529165148E+02 gamma(00000434)=0.134576529165148E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 434 z1= 1 -.260625499273625E-04 0.000000000000000E+00 z1= 2 0.121863130287878E-03 0.000000000000000E+00 z1= 3 0.582769266838448E-02 0.000000000000000E+00 alpha(00000434)=0.000000000000000E+00 beta (00000435)=0.133071930301184E+02 gamma(00000435)=0.133071930301184E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 435 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000435)=0.000000000000000E+00 beta (00000436)=0.131666969290794E+02 gamma(00000436)=0.131666969290794E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 436 z1= 1 -.180414172808621E-04 0.000000000000000E+00 z1= 2 -.195486057319114E-03 0.000000000000000E+00 z1= 3 -.581315185359783E-02 0.000000000000000E+00 alpha(00000436)=0.000000000000000E+00 beta (00000437)=0.125579607255071E+02 gamma(00000437)=0.125579607255071E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 437 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000437)=0.000000000000000E+00 beta (00000438)=0.131914195269071E+02 gamma(00000438)=0.131914195269071E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 438 z1= 1 -.310664772351088E-04 0.000000000000000E+00 z1= 2 0.111837367222399E-03 0.000000000000000E+00 z1= 3 0.564124354438876E-02 0.000000000000000E+00 alpha(00000438)=0.000000000000000E+00 beta (00000439)=0.124692642240776E+02 gamma(00000439)=0.124692642240776E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 439 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000439)=0.000000000000000E+00 beta (00000440)=0.125614300790789E+02 gamma(00000440)=0.125614300790789E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 440 z1= 1 -.253375950394970E-04 0.000000000000000E+00 z1= 2 -.209047578860314E-03 0.000000000000000E+00 z1= 3 -.562049782644201E-02 0.000000000000000E+00 alpha(00000440)=0.000000000000000E+00 beta (00000441)=0.128023049678874E+02 gamma(00000441)=0.128023049678874E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 441 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000441)=0.000000000000000E+00 beta (00000442)=0.131479726156404E+02 gamma(00000442)=0.131479726156404E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 442 z1= 1 -.514814762984378E-04 0.000000000000000E+00 z1= 2 0.101757182121711E-03 0.000000000000000E+00 z1= 3 0.533044488195912E-02 0.000000000000000E+00 alpha(00000442)=0.000000000000000E+00 beta (00000443)=0.129500775582839E+02 gamma(00000443)=0.129500775582839E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 443 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000443)=0.000000000000000E+00 beta (00000444)=0.135521566106260E+02 gamma(00000444)=0.135521566106260E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 444 z1= 1 -.402067073986719E-04 0.000000000000000E+00 z1= 2 -.224336419217568E-03 0.000000000000000E+00 z1= 3 -.524181480847123E-02 0.000000000000000E+00 alpha(00000444)=0.000000000000000E+00 beta (00000445)=0.128130720612214E+02 gamma(00000445)=0.128130720612214E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 445 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000445)=0.000000000000000E+00 beta (00000446)=0.136304399638974E+02 gamma(00000446)=0.136304399638974E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 446 z1= 1 -.562086175142400E-04 0.000000000000000E+00 z1= 2 0.898040911294283E-04 0.000000000000000E+00 z1= 3 0.540417369371184E-02 0.000000000000000E+00 alpha(00000446)=0.000000000000000E+00 beta (00000447)=0.125875691394397E+02 gamma(00000447)=0.125875691394397E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 447 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000447)=0.000000000000000E+00 beta (00000448)=0.131673178874931E+02 gamma(00000448)=0.131673178874931E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 448 z1= 1 -.247201402853279E-04 0.000000000000000E+00 z1= 2 -.192118077163152E-03 0.000000000000000E+00 z1= 3 -.573584896108563E-02 0.000000000000000E+00 alpha(00000448)=0.000000000000000E+00 beta (00000449)=0.125847933729154E+02 gamma(00000449)=0.125847933729154E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 449 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000449)=0.000000000000000E+00 beta (00000450)=0.133692470534363E+02 gamma(00000450)=0.133692470534363E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 450 z1= 1 -.470743371307120E-04 0.000000000000000E+00 z1= 2 0.939232472131563E-04 0.000000000000000E+00 z1= 3 0.567021326401207E-02 0.000000000000000E+00 alpha(00000450)=0.000000000000000E+00 beta (00000451)=0.126297494564811E+02 gamma(00000451)=0.126297494564811E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 451 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000451)=0.000000000000000E+00 beta (00000452)=0.137652166300765E+02 gamma(00000452)=0.137652166300765E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 452 z1= 1 -.553267042545239E-05 0.000000000000000E+00 z1= 2 -.143162217093527E-03 0.000000000000000E+00 z1= 3 -.512717685637428E-02 0.000000000000000E+00 alpha(00000452)=0.000000000000000E+00 beta (00000453)=0.119359385666586E+02 gamma(00000453)=0.119359385666586E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 453 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000453)=0.000000000000000E+00 beta (00000454)=0.131853666418608E+02 gamma(00000454)=0.131853666418608E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 454 z1= 1 -.295460104781643E-04 0.000000000000000E+00 z1= 2 0.886171504458659E-04 0.000000000000000E+00 z1= 3 0.436372403876695E-02 0.000000000000000E+00 alpha(00000454)=0.000000000000000E+00 beta (00000455)=0.122669691279308E+02 gamma(00000455)=0.122669691279308E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 455 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000455)=0.000000000000000E+00 beta (00000456)=0.130873885092554E+02 gamma(00000456)=0.130873885092554E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 456 z1= 1 0.462526830898697E-05 0.000000000000000E+00 z1= 2 -.856601208753194E-04 0.000000000000000E+00 z1= 3 -.349435916237935E-02 0.000000000000000E+00 alpha(00000456)=0.000000000000000E+00 beta (00000457)=0.123738057354620E+02 gamma(00000457)=0.123738057354620E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 457 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000457)=0.000000000000000E+00 beta (00000458)=0.132355474023954E+02 gamma(00000458)=0.132355474023954E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 458 z1= 1 -.216693847367663E-04 0.000000000000000E+00 z1= 2 0.890068593439419E-04 0.000000000000000E+00 z1= 3 0.294074154220148E-02 0.000000000000000E+00 alpha(00000458)=0.000000000000000E+00 beta (00000459)=0.127953233129089E+02 gamma(00000459)=0.127953233129089E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 459 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000459)=0.000000000000000E+00 beta (00000460)=0.131456577131135E+02 gamma(00000460)=0.131456577131135E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 460 z1= 1 0.182785143177754E-04 0.000000000000000E+00 z1= 2 -.423851232810831E-04 0.000000000000000E+00 z1= 3 -.284219026646854E-02 0.000000000000000E+00 alpha(00000460)=0.000000000000000E+00 beta (00000461)=0.129380217068124E+02 gamma(00000461)=0.129380217068124E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 461 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000461)=0.000000000000000E+00 beta (00000462)=0.127925760617657E+02 gamma(00000462)=0.127925760617657E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 462 z1= 1 -.178751464491230E-04 0.000000000000000E+00 z1= 2 0.920215999778908E-04 0.000000000000000E+00 z1= 3 0.324156691674311E-02 0.000000000000000E+00 alpha(00000462)=0.000000000000000E+00 beta (00000463)=0.127057683108702E+02 gamma(00000463)=0.127057683108702E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 463 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000463)=0.000000000000000E+00 beta (00000464)=0.136760306224048E+02 gamma(00000464)=0.136760306224048E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 464 z1= 1 0.283318056666404E-04 0.000000000000000E+00 z1= 2 -.103437159440212E-04 0.000000000000000E+00 z1= 3 -.351385825927351E-02 0.000000000000000E+00 alpha(00000464)=0.000000000000000E+00 beta (00000465)=0.124275783227339E+02 gamma(00000465)=0.124275783227339E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 465 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000465)=0.000000000000000E+00 beta (00000466)=0.130488667043091E+02 gamma(00000466)=0.130488667043091E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 466 z1= 1 -.149002649012030E-04 0.000000000000000E+00 z1= 2 0.889797330076095E-04 0.000000000000000E+00 z1= 3 0.376429349725405E-02 0.000000000000000E+00 alpha(00000466)=0.000000000000000E+00 beta (00000467)=0.128138071694893E+02 gamma(00000467)=0.128138071694893E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 467 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000467)=0.000000000000000E+00 beta (00000468)=0.132763593664150E+02 gamma(00000468)=0.132763593664150E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 468 z1= 1 0.328379800967979E-04 0.000000000000000E+00 z1= 2 0.123361987428380E-04 0.000000000000000E+00 z1= 3 -.357975633430930E-02 0.000000000000000E+00 alpha(00000468)=0.000000000000000E+00 beta (00000469)=0.130106810905349E+02 gamma(00000469)=0.130106810905349E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 469 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000469)=0.000000000000000E+00 beta (00000470)=0.130218647207440E+02 gamma(00000470)=0.130218647207440E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 470 z1= 1 -.107050021740174E-04 0.000000000000000E+00 z1= 2 0.845213589689218E-04 0.000000000000000E+00 z1= 3 0.317129816756030E-02 0.000000000000000E+00 alpha(00000470)=0.000000000000000E+00 beta (00000471)=0.126930684368173E+02 gamma(00000471)=0.126930684368173E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 471 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000471)=0.000000000000000E+00 beta (00000472)=0.131642311593630E+02 gamma(00000472)=0.131642311593630E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 472 z1= 1 0.371844695776243E-04 0.000000000000000E+00 z1= 2 0.207064529351351E-04 0.000000000000000E+00 z1= 3 -.294415356191593E-02 0.000000000000000E+00 alpha(00000472)=0.000000000000000E+00 beta (00000473)=0.127720709424309E+02 gamma(00000473)=0.127720709424309E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 473 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000473)=0.000000000000000E+00 beta (00000474)=0.136361984619907E+02 gamma(00000474)=0.136361984619907E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 474 z1= 1 -.753952559784572E-05 0.000000000000000E+00 z1= 2 0.665387671647844E-04 0.000000000000000E+00 z1= 3 0.305098650620052E-02 0.000000000000000E+00 alpha(00000474)=0.000000000000000E+00 beta (00000475)=0.128655478487465E+02 gamma(00000475)=0.128655478487465E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 475 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000475)=0.000000000000000E+00 beta (00000476)=0.131367760250667E+02 gamma(00000476)=0.131367760250667E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 476 z1= 1 0.293077855231445E-04 0.000000000000000E+00 z1= 2 0.154686511695707E-04 0.000000000000000E+00 z1= 3 -.338569279461591E-02 0.000000000000000E+00 alpha(00000476)=0.000000000000000E+00 beta (00000477)=0.126646159453091E+02 gamma(00000477)=0.126646159453091E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 477 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000477)=0.000000000000000E+00 beta (00000478)=0.130004392365802E+02 gamma(00000478)=0.130004392365802E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 478 z1= 1 -.881967630058365E-05 0.000000000000000E+00 z1= 2 0.358414323852761E-04 0.000000000000000E+00 z1= 3 0.353282347808530E-02 0.000000000000000E+00 alpha(00000478)=0.000000000000000E+00 beta (00000479)=0.127337484368685E+02 gamma(00000479)=0.127337484368685E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 479 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000479)=0.000000000000000E+00 beta (00000480)=0.129113456608092E+02 gamma(00000480)=0.129113456608092E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 480 z1= 1 0.218885996748644E-04 0.000000000000000E+00 z1= 2 0.125457194157074E-04 0.000000000000000E+00 z1= 3 -.361018127609862E-02 0.000000000000000E+00 alpha(00000480)=0.000000000000000E+00 beta (00000481)=0.127113440831952E+02 gamma(00000481)=0.127113440831952E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 481 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000481)=0.000000000000000E+00 beta (00000482)=0.126051001578645E+02 gamma(00000482)=0.126051001578645E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 482 z1= 1 0.647579314919924E-06 0.000000000000000E+00 z1= 2 0.288060710666878E-05 0.000000000000000E+00 z1= 3 0.393958201062320E-02 0.000000000000000E+00 alpha(00000482)=0.000000000000000E+00 beta (00000483)=0.130817120067483E+02 gamma(00000483)=0.130817120067483E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 483 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000483)=0.000000000000000E+00 beta (00000484)=0.132797894648614E+02 gamma(00000484)=0.132797894648614E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 484 z1= 1 0.187987189850335E-04 0.000000000000000E+00 z1= 2 0.160385151143881E-04 0.000000000000000E+00 z1= 3 -.422856976196502E-02 0.000000000000000E+00 alpha(00000484)=0.000000000000000E+00 beta (00000485)=0.118835976648465E+02 gamma(00000485)=0.118835976648465E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 485 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000485)=0.000000000000000E+00 beta (00000486)=0.136952446867865E+02 gamma(00000486)=0.136952446867865E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 486 z1= 1 0.156683039812953E-04 0.000000000000000E+00 z1= 2 -.225278326016242E-04 0.000000000000000E+00 z1= 3 0.396843510546074E-02 0.000000000000000E+00 alpha(00000486)=0.000000000000000E+00 beta (00000487)=0.123032034422385E+02 gamma(00000487)=0.123032034422385E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 487 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000487)=0.000000000000000E+00 beta (00000488)=0.135984219825219E+02 gamma(00000488)=0.135984219825219E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 488 z1= 1 0.218061734927329E-04 0.000000000000000E+00 z1= 2 0.294329951298817E-04 0.000000000000000E+00 z1= 3 -.335879823389492E-02 0.000000000000000E+00 alpha(00000488)=0.000000000000000E+00 beta (00000489)=0.123969744336023E+02 gamma(00000489)=0.123969744336023E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 489 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000489)=0.000000000000000E+00 beta (00000490)=0.134709127039133E+02 gamma(00000490)=0.134709127039133E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 490 z1= 1 0.264302026640360E-04 0.000000000000000E+00 z1= 2 -.485086385223749E-04 0.000000000000000E+00 z1= 3 0.229912051995884E-02 0.000000000000000E+00 alpha(00000490)=0.000000000000000E+00 beta (00000491)=0.124908356609021E+02 gamma(00000491)=0.124908356609021E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 491 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000491)=0.000000000000000E+00 beta (00000492)=0.136358840724126E+02 gamma(00000492)=0.136358840724126E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 492 z1= 1 0.311104510414436E-04 0.000000000000000E+00 z1= 2 0.492729887217757E-04 0.000000000000000E+00 z1= 3 -.156707789892470E-02 0.000000000000000E+00 alpha(00000492)=0.000000000000000E+00 beta (00000493)=0.127184163775541E+02 gamma(00000493)=0.127184163775541E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 493 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000493)=0.000000000000000E+00 beta (00000494)=0.130806301154759E+02 gamma(00000494)=0.130806301154759E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 494 z1= 1 0.304801308918308E-04 0.000000000000000E+00 z1= 2 -.650063385206896E-04 0.000000000000000E+00 z1= 3 0.102831563331598E-02 0.000000000000000E+00 alpha(00000494)=0.000000000000000E+00 beta (00000495)=0.123735422231324E+02 gamma(00000495)=0.123735422231324E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 495 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000495)=0.000000000000000E+00 beta (00000496)=0.133354253001010E+02 gamma(00000496)=0.133354253001010E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 496 z1= 1 0.439220702511433E-04 0.000000000000000E+00 z1= 2 0.676544301148002E-04 0.000000000000000E+00 z1= 3 -.388720070389937E-03 0.000000000000000E+00 alpha(00000496)=0.000000000000000E+00 beta (00000497)=0.124443080958355E+02 gamma(00000497)=0.124443080958355E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 497 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000497)=0.000000000000000E+00 beta (00000498)=0.137541440731347E+02 gamma(00000498)=0.137541440731347E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 498 z1= 1 0.379489709239012E-04 0.000000000000000E+00 z1= 2 -.763317606244319E-04 0.000000000000000E+00 z1= 3 -.536060897142789E-04 0.000000000000000E+00 alpha(00000498)=0.000000000000000E+00 beta (00000499)=0.125719867252203E+02 gamma(00000499)=0.125719867252203E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 499 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000499)=0.000000000000000E+00 beta (00000500)=0.134598749112988E+02 gamma(00000500)=0.134598749112988E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 500 z1= 1 0.454859504621235E-04 0.000000000000000E+00 z1= 2 0.864499093102138E-04 0.000000000000000E+00 z1= 3 -.498000644530948E-05 0.000000000000000E+00 alpha(00000500)=0.000000000000000E+00 beta (00000501)=0.122922115717978E+02 gamma(00000501)=0.122922115717978E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal End of Lanczos iterations Finished linear response calculation... lr_main : 2805.86s CPU 3046.63s WALL ( 1 calls) lr_solve_e : 1.36s CPU 1.98s WALL ( 1 calls) one_step : 2800.79s CPU 3040.45s WALL ( 1500 calls) lr_apply : 2798.14s CPU 3037.42s WALL ( 3006 calls) lr_apply_int : 2759.36s CPU 2996.92s WALL ( 1503 calls) lr_apply_no : 38.78s CPU 40.51s WALL ( 1503 calls) lr_apply : 2798.14s CPU 3037.42s WALL ( 3006 calls) h_psi : 75.38s CPU 78.78s WALL ( 3006 calls) lr_calc_dens : 948.50s CPU 1007.65s WALL ( 1503 calls) lr_ortho : 0.50s CPU 0.52s WALL ( 3000 calls) interaction : 16.97s CPU 18.00s WALL ( 1503 calls) lr_dot : 0.27s CPU 0.25s WALL ( 3753 calls) US routines s_psi : 0.93s CPU 0.93s WALL ( 4634 calls) lr_sm1_psi : 1.47s CPU 1.51s WALL ( 3009 calls) General routines calbec : 4.54s CPU 4.65s WALL ( 9161 calls) fft : 717.51s CPU 772.21s WALL ( 21059 calls) ffts : 19.19s CPU 20.21s WALL ( 3007 calls) fftw : 86.77s CPU 91.48s WALL ( 18232 calls) interpolate : 126.73s CPU 145.19s WALL ( 3007 calls) davcio : 0.00s CPU 0.00s WALL ( 49 calls) addusdens : 843.23s CPU 892.62s WALL ( 1503 calls) Parallel routines fft_scatter : 292.05s CPU 313.35s WALL ( 42298 calls) TDDFPT : 46m45.87s CPU 50m46.66s WALL This run was terminated on: 13: 6: 2 12Jan2012 =------------------------------------------------------------------------------= JOB DONE. =------------------------------------------------------------------------------= TDDFPT/Examples/make.sys0000644000175000017500000000243712341371500013360 0ustar mbamba.SUFFIXES : .pw-in .tddfpt-in .tddfpt_pp-in .pw-out .tddfpt-out .tddfpt_pp-out .tddfpt-st-in .tddfpt-st-out .tddfpt-in-s2 .tddfpt-out-s2 .tddfpt-in-s2-2 .tddfpt-out-s2-2 .pw-ref .tddfpt-ref .tddfpt-ref-s2 .tddfpt-ref-s2-2 ################################################## # RECOMMENDED USER EDITABLE PART STARTS HERE # ################################################## #An example on how to use these variables are as follows #RUNNER = openmpi-1.4.3/bin/mpirun -np 8 #PWSCF = "../../../bin/pw.x" -ndiag 4 RUNNER = PWSCF = "../../../bin/pw.x" TDDFPT = "../../../bin/turbo_lanczos.x" TDDFPT_PP = "../../../bin/turbo_spectrum.x" ################################################## # End of recommended editable part # ################################################## check_pw = "../tools/check_pw.tcl" check_tddfpt = "../tools/check_tddfpt.tcl" check_pp = "../tools/check_pp.tcl" check_move_cube = "../tools/check_move_cube.sh" .pw-in.pw-out: $(RUNNER) $(PWSCF) < $< > $@ .tddfpt_pp-in.tddfpt_pp-out: $(RUNNER) $(TDDFPT_PP) < $< > $@ .tddfpt-in.tddfpt-out: $(RUNNER) $(TDDFPT) < $< > $@ .tddfpt-st-in.tddfpt-st-out: $(RUNNER) $(TDDFPT) < $< > $@ .tddfpt-in-s2.tddfpt-out-s2: $(RUNNER) $(TDDFPT) < $< > $@ .tddfpt-in-s2-2.tddfpt-out-s2-2: $(RUNNER) $(TDDFPT) < $< > $@ TDDFPT/Examples/README0000644000175000017500000000143512341371500012560 0ustar mbambaTime Dependent Density Functional Perturbation Theory (TDDFPT) To run all examples do "make normal_test" "make clean" resets the tests "make small_test" runs a short test, useful for checking compilation each example can be run separately by running "make" in its designated directory make.sys can be edited for parallel executions of tests by editing "RUNNER" variable (i.e. RUNNER=mpirun -np 4) Examples: Benzene: Benzene molecule, Tests the real_space and tqr implementations CH4: Tests Norm Conserving PP implementation CH4-PR: Tests charge response algorithm SiH4: Tests Ultrasoft PP implementation CH4-BOND: This is an example that shows visual analysis of a softened bond in a set of degenerate bonds. tools: Tools to compare data. CH4-DAV: Example of using davidson algorithm TDDFPT/Examples/CH4-TDHF/0000755000175000017500000000000012341371517013006 5ustar mbambaTDDFPT/Examples/CH4-TDHF/CH4.tddfpt-in0000644000175000017500000000017012341371500015165 0ustar mbamba&lr_input prefix="ch4", outdir='./out', restart_step=250, / &lr_control itermax=500, ipol=4 / TDDFPT/Examples/CH4-TDHF/CH4.tddfpt-st-in0000644000175000017500000000016612341371500015616 0ustar mbamba&lr_input prefix="ch4", outdir='./out', restart_step=250, / &lr_control itermax=5, ipol=1 / TDDFPT/Examples/CH4-TDHF/CH4.pw-in0000644000175000017500000000126712341371500014336 0ustar mbamba&control calculation = 'scf' title = 'TDDFPT CH4 Test (TDHF)' restart_mode='from_scratch', pseudo_dir = '../pseudo', outdir='./out', prefix='ch4' etot_conv_thr=1d-6 / &system ibrav = 1, celldm(1) = 15, nat = 5, ntyp = 2, ecutwfc = 25, input_dft = 'hf', nosym=.true. / &electrons / &ions / ATOMIC_SPECIES C 1.0 C.pz-vbc.UPF H 1.0 H.pz-vbc.UPF ATOMIC_POSITIONS {Angstrom} C 0.000000000 0.000000000 0.000000000 H 0.642814093 0.642814093 0.642814093 H -0.642814093 -0.642814093 0.642814093 H 0.642814093 -0.642814093 -0.642814093 H -0.642814093 0.642814093 -0.642814093 K_POINTS {gamma} TDDFPT/Examples/CH4-TDHF/CH4.pw-ref0000644000175000017500000005320612341371500014504 0ustar mbamba Program PWSCF v.4.3.2 starts on 14Dec2011 at 16:52:54 This program is part of the open-source Quantum ESPRESSO suite for quantum simulation of materials; please cite "P. Giannozzi et al., J. Phys.:Condens. Matter 21 395502 (2009); URL http://www.quantum-espresso.org", in publications or presentations arising from this work. More details at http://www.quantum-espresso.org/quote.php Parallel version (MPI), running on 4 processors R & G space division: proc/pool = 4 EXPERIMENTAL VERSION WITH EXACT EXCHANGE Current dimensions of program PWSCF are: Max number of different atomic species (ntypx) = 10 Max number of k-points (npk) = 40000 Max angular momentum in pseudopotentials (lmaxx) = 3 Reading input from CH4.pw-in Warning: card &IONS ignored Warning: card / ignored IMPORTANT: XC functional enforced from input : Exchange-correlation = HF ( 5 0 0 0 0) EXX-fraction = 1.00 Any further DFT definition will be discarded Please, verify this is what you really want file H.pz-vbc.UPF: wavefunction(s) 1S renormalized gamma-point specific algorithms are used Subspace diagonalization in iterative solution of the eigenvalue problem: a serial algorithm will be used Parallelization info -------------------- sticks: dense smooth PW G-vecs: dense smooth PW Min 445 445 108 14262 14262 1776 Max 452 452 110 14264 14264 1783 Sum 1789 1789 437 57051 57051 7123 Tot 895 895 219 Title: TDDFPT CH4 Test (TDHF) bravais-lattice index = 1 lattice parameter (alat) = 15.0000 a.u. unit-cell volume = 3375.0000 (a.u.)^3 number of atoms/cell = 5 number of atomic types = 2 number of electrons = 8.00 number of Kohn-Sham states= 4 kinetic-energy cutoff = 25.0000 Ry charge density cutoff = 100.0000 Ry convergence threshold = 1.0E-06 mixing beta = 0.7000 number of iterations used = 8 plain mixing Exchange-correlation = HF ( 5 0 0 0 0) EXX-fraction = 1.00 celldm(1)= 15.000000 celldm(2)= 0.000000 celldm(3)= 0.000000 celldm(4)= 0.000000 celldm(5)= 0.000000 celldm(6)= 0.000000 crystal axes: (cart. coord. in units of alat) a(1) = ( 1.000000 0.000000 0.000000 ) a(2) = ( 0.000000 1.000000 0.000000 ) a(3) = ( 0.000000 0.000000 1.000000 ) reciprocal axes: (cart. coord. in units 2 pi/alat) b(1) = ( 1.000000 0.000000 0.000000 ) b(2) = ( 0.000000 1.000000 0.000000 ) b(3) = ( 0.000000 0.000000 1.000000 ) PseudoPot. # 1 for C read from file: ../pseudo/C.pz-vbc.UPF MD5 check sum: ab53dd623bfeb79c5a7b057bc96eae20 Pseudo is Norm-conserving, Zval = 4.0 Generated by new atomic code, or converted to UPF format Using radial grid of 269 points, 1 beta functions with: l(1) = 0 PseudoPot. # 2 for H read from file: ../pseudo/H.pz-vbc.UPF MD5 check sum: 90becb985b714f09656c73597998d266 Pseudo is Norm-conserving, Zval = 1.0 Generated by new atomic code, or converted to UPF format Using radial grid of 131 points, 0 beta functions with: atomic species valence mass pseudopotential C 4.00 1.00000 C ( 1.00) H 1.00 1.00000 H ( 1.00) No symmetry found Cartesian axes site n. atom positions (alat units) 1 C tau( 1) = ( 0.0000000 0.0000000 0.0000000 ) 2 H tau( 2) = ( 0.0809828 0.0809828 0.0809828 ) 3 H tau( 3) = ( -0.0809828 -0.0809828 0.0809828 ) 4 H tau( 4) = ( 0.0809828 -0.0809828 -0.0809828 ) 5 H tau( 5) = ( -0.0809828 0.0809828 -0.0809828 ) number of k points= 1 cart. coord. in units 2pi/alat k( 1) = ( 0.0000000 0.0000000 0.0000000), wk = 2.0000000 Dense grid: 28526 G-vectors FFT dimensions: ( 48, 48, 48) Largest allocated arrays est. size (Mb) dimensions Kohn-Sham Wavefunctions 0.05 Mb ( 888, 4) NL pseudopotentials 0.01 Mb ( 888, 1) Each V/rho on FFT grid 0.42 Mb ( 27648) Each G-vector array 0.05 Mb ( 7132) G-vector shells 0.00 Mb ( 461) Largest temporary arrays est. size (Mb) dimensions Auxiliary wavefunctions 0.11 Mb ( 888, 16) Each subspace H/S matrix 0.00 Mb ( 16, 16) Each matrix 0.00 Mb ( 1, 4) Arrays for rho mixing 3.38 Mb ( 27648, 8) Initial potential from superposition of free atoms Check: negative starting charge= -0.007168 starting charge 7.99987, renormalised to 8.00000 negative rho (up, down): 0.717E-02 0.000E+00 Starting wfc are 8 atomic wfcs total cpu time spent up to now is 0.1 secs per-process dynamical memory: 10.3 Mb Self-consistent Calculation iteration # 1 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 1.00E-02, avg # of iterations = 2.0 negative rho (up, down): 0.200E-02 0.000E+00 total cpu time spent up to now is 0.2 secs total energy = -14.80814773 Ry Harris-Foulkes estimate = -15.15961066 Ry estimated scf accuracy < 0.50888480 Ry iteration # 2 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 6.36E-03, avg # of iterations = 2.0 negative rho (up, down): 0.906E-03 0.000E+00 total cpu time spent up to now is 0.3 secs total energy = -14.92076762 Ry Harris-Foulkes estimate = -15.02287026 Ry estimated scf accuracy < 0.18489615 Ry iteration # 3 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 2.31E-03, avg # of iterations = 2.0 negative rho (up, down): 0.713E-06 0.000E+00 total cpu time spent up to now is 0.4 secs total energy = -14.96016761 Ry Harris-Foulkes estimate = -14.96260917 Ry estimated scf accuracy < 0.00450446 Ry iteration # 4 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 5.63E-05, avg # of iterations = 2.0 negative rho (up, down): 0.161E-04 0.000E+00 total cpu time spent up to now is 0.5 secs total energy = -14.96124904 Ry Harris-Foulkes estimate = -14.96142339 Ry estimated scf accuracy < 0.00035479 Ry iteration # 5 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 4.43E-06, avg # of iterations = 1.0 negative rho (up, down): 0.122E-06 0.000E+00 total cpu time spent up to now is 0.7 secs total energy = -14.96127571 Ry Harris-Foulkes estimate = -14.96127812 Ry estimated scf accuracy < 0.00000697 Ry iteration # 6 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 8.71E-08, avg # of iterations = 3.0 total cpu time spent up to now is 0.9 secs total energy = -14.96127846 Ry Harris-Foulkes estimate = -14.96128012 Ry estimated scf accuracy < 0.00000420 Ry iteration # 7 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 5.24E-08, avg # of iterations = 1.0 total cpu time spent up to now is 1.0 secs End of self-consistent calculation k = 0.0000 0.0000 0.0000 ( 3562 PWs) bands (ev): -15.3211 -7.7372 -7.7372 -7.7372 EXX: now go back to refine exchange calculation -11.4181117787429 Self-consistent Calculation iteration # 1 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 5.24E-08, avg # of iterations = 5.0 total cpu time spent up to now is 2.1 secs total energy = -15.47214725 Ry Harris-Foulkes estimate = -15.47440932 Ry estimated scf accuracy < 0.00248579 Ry iteration # 2 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 3.11E-05, avg # of iterations = 2.0 total cpu time spent up to now is 2.6 secs total energy = -15.47244308 Ry Harris-Foulkes estimate = -15.47249371 Ry estimated scf accuracy < 0.00005354 Ry iteration # 3 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 6.69E-07, avg # of iterations = 2.0 total cpu time spent up to now is 3.2 secs total energy = -15.47245663 Ry Harris-Foulkes estimate = -15.47246288 Ry estimated scf accuracy < 0.00000864 Ry iteration # 4 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 1.08E-07, avg # of iterations = 2.0 total cpu time spent up to now is 3.7 secs End of self-consistent calculation k = 0.0000 0.0000 0.0000 ( 3562 PWs) bands (ev): -25.2261 -14.1883 -14.1883 -14.1883 -11.4181117787429 -11.4850559178145 -11.5601429997824 est. exchange err (dexx) = 0.00407147 Ry ! total energy = -15.47652996 Ry Harris-Foulkes estimate = -15.47653005 Ry estimated scf accuracy < 0.00000009 Ry The total energy is the sum of the following terms: one-electron contribution = -45.93517830 Ry hartree contribution = 17.98537359 Ry xc contribution = 0.00000000 Ry ewald contribution = 6.76829034 Ry - averaged Fock potential = 11.48505592 Ry + Fock energy = -5.78007150 Ry NOW GO BACK TO REFINE HYBRID CALCULATION Self-consistent Calculation iteration # 1 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 1.08E-07, avg # of iterations = 4.0 total cpu time spent up to now is 4.6 secs total energy = -15.47805970 Ry Harris-Foulkes estimate = -15.47844094 Ry estimated scf accuracy < 0.00041895 Ry iteration # 2 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 5.24E-06, avg # of iterations = 2.0 total cpu time spent up to now is 5.1 secs total energy = -15.47811287 Ry Harris-Foulkes estimate = -15.47811737 Ry estimated scf accuracy < 0.00000473 Ry iteration # 3 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 5.91E-08, avg # of iterations = 2.0 total cpu time spent up to now is 5.7 secs End of self-consistent calculation k = 0.0000 0.0000 0.0000 ( 3562 PWs) bands (ev): -25.2063 -14.2282 -14.2282 -14.2282 -11.5601429997824 -11.5869896356417 -11.6151434444530 est. exchange err (dexx) = 0.00065359 Ry ! total energy = -15.47876746 Ry Harris-Foulkes estimate = -15.47876758 Ry estimated scf accuracy < 0.00000012 Ry The total energy is the sum of the following terms: one-electron contribution = -46.07506845 Ry hartree contribution = 18.04859274 Ry xc contribution = 0.00000000 Ry ewald contribution = 6.76829034 Ry - averaged Fock potential = 11.58698964 Ry + Fock energy = -5.80757172 Ry NOW GO BACK TO REFINE HYBRID CALCULATION Self-consistent Calculation iteration # 1 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 5.91E-08, avg # of iterations = 4.0 total cpu time spent up to now is 7.6 secs total energy = -15.47903574 Ry Harris-Foulkes estimate = -15.47911261 Ry estimated scf accuracy < 0.00008447 Ry iteration # 2 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 1.06E-06, avg # of iterations = 2.0 total cpu time spent up to now is 8.2 secs total energy = -15.47904808 Ry Harris-Foulkes estimate = -15.47904963 Ry estimated scf accuracy < 0.00000168 Ry iteration # 3 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 2.09E-08, avg # of iterations = 2.0 total cpu time spent up to now is 8.7 secs End of self-consistent calculation k = 0.0000 0.0000 0.0000 ( 3562 PWs) bands (ev): -25.1943 -14.2445 -14.2445 -14.2445 -11.6151434444530 -11.6256365710141 -11.6363781349041 est. exchange err (dexx) = 0.00012422 Ry ! total energy = -15.47917265 Ry Harris-Foulkes estimate = -15.47917279 Ry estimated scf accuracy < 0.00000014 Ry The total energy is the sum of the following terms: one-electron contribution = -46.12291951 Ry hartree contribution = 18.06800902 Ry xc contribution = 0.00000000 Ry ewald contribution = 6.76829034 Ry - averaged Fock potential = 11.62563657 Ry + Fock energy = -5.81818907 Ry NOW GO BACK TO REFINE HYBRID CALCULATION Self-consistent Calculation iteration # 1 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 2.09E-08, avg # of iterations = 4.0 total cpu time spent up to now is 9.6 secs total energy = -15.47922451 Ry Harris-Foulkes estimate = -15.47924048 Ry estimated scf accuracy < 0.00001755 Ry iteration # 2 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 2.19E-07, avg # of iterations = 2.0 total cpu time spent up to now is 10.2 secs End of self-consistent calculation k = 0.0000 0.0000 0.0000 ( 3562 PWs) bands (ev): -25.1994 -14.2609 -14.2609 -14.2609 -11.6363781349041 -11.6411785936653 -11.6460292122734 est. exchange err (dexx) = 0.00002508 Ry ! total energy = -15.47925233 Ry Harris-Foulkes estimate = -15.47925284 Ry estimated scf accuracy < 0.00000051 Ry The total energy is the sum of the following terms: one-electron contribution = -46.14287532 Ry hartree contribution = 18.07716867 Ry xc contribution = 0.00000000 Ry ewald contribution = 6.76829034 Ry - averaged Fock potential = 11.64117859 Ry + Fock energy = -5.82301461 Ry NOW GO BACK TO REFINE HYBRID CALCULATION Self-consistent Calculation iteration # 1 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 2.19E-07, avg # of iterations = 2.0 total cpu time spent up to now is 10.9 secs total energy = -15.47926240 Ry Harris-Foulkes estimate = -15.47926641 Ry estimated scf accuracy < 0.00000441 Ry iteration # 2 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 5.51E-08, avg # of iterations = 2.0 total cpu time spent up to now is 11.4 secs End of self-consistent calculation k = 0.0000 0.0000 0.0000 ( 3562 PWs) bands (ev): -25.1966 -14.2635 -14.2635 -14.2635 -11.6460292122734 -11.6478401445780 -11.6496610327406 est. exchange err (dexx) = 0.00000498 Ry ! total energy = -15.47926824 Ry Harris-Foulkes estimate = -15.47926845 Ry estimated scf accuracy < 0.00000021 Ry The total energy is the sum of the following terms: one-electron contribution = -46.15007957 Ry hartree contribution = 18.07951137 Ry xc contribution = 0.00000000 Ry ewald contribution = 6.76829034 Ry - averaged Fock potential = 11.64784014 Ry + Fock energy = -5.82483052 Ry NOW GO BACK TO REFINE HYBRID CALCULATION Self-consistent Calculation iteration # 1 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 5.51E-08, avg # of iterations = 2.0 total cpu time spent up to now is 12.1 secs total energy = -15.47927028 Ry Harris-Foulkes estimate = -15.47927152 Ry estimated scf accuracy < 0.00000137 Ry iteration # 2 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 1.71E-08, avg # of iterations = 2.0 total cpu time spent up to now is 12.6 secs End of self-consistent calculation k = 0.0000 0.0000 0.0000 ( 3562 PWs) bands (ev): -25.1958 -14.2650 -14.2650 -14.2650 -11.6496610327406 -11.6503659355321 -11.6510729053309 est. exchange err (dexx) = 0.00000103 Ry ! total energy = -15.47927164 Ry Harris-Foulkes estimate = -15.47927177 Ry estimated scf accuracy < 0.00000012 Ry The total energy is the sum of the following terms: one-electron contribution = -46.15236648 Ry hartree contribution = 18.07997501 Ry xc contribution = 0.00000000 Ry ewald contribution = 6.76829034 Ry - averaged Fock potential = 11.65036594 Ry + Fock energy = -5.82553645 Ry NOW GO BACK TO REFINE HYBRID CALCULATION Self-consistent Calculation iteration # 1 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 1.71E-08, avg # of iterations = 2.0 total cpu time spent up to now is 14.3 secs End of self-consistent calculation k = 0.0000 0.0000 0.0000 ( 3562 PWs) bands (ev): -25.1916 -14.2633 -14.2633 -14.2633 -11.6510729053309 -11.6510663790173 -11.6510610467346 est. exchange err (dexx) = 0.00000060 Ry ! total energy = -15.47927262 Ry Harris-Foulkes estimate = -15.47927313 Ry estimated scf accuracy < 0.00000051 Ry The total energy is the sum of the following terms: one-electron contribution = -46.15081621 Ry hartree contribution = 18.07771740 Ry xc contribution = 0.00000000 Ry ewald contribution = 6.76829034 Ry - averaged Fock potential = 11.65106638 Ry + Fock energy = -5.82553052 Ry convergence has been achieved in 1 iterations Writing output data file ch4.save init_run : 0.06s CPU 0.11s WALL ( 1 calls) electrons : 7.25s CPU 14.25s WALL ( 1 calls) Called by init_run: wfcinit : 0.01s CPU 0.03s WALL ( 1 calls) potinit : 0.02s CPU 0.03s WALL ( 1 calls) Called by electrons: c_bands : 5.25s CPU 8.58s WALL ( 24 calls) sum_band : 0.25s CPU 0.58s WALL ( 24 calls) v_of_rho : 0.13s CPU 0.20s WALL ( 26 calls) mix_rho : 0.11s CPU 0.17s WALL ( 24 calls) Called by c_bands: init_us_2 : 0.01s CPU 0.01s WALL ( 49 calls) regterg : 5.24s CPU 8.57s WALL ( 24 calls) Called by *egterg: h_psi : 5.20s CPU 8.50s WALL ( 81 calls) g_psi : 0.01s CPU 0.01s WALL ( 56 calls) rdiaghg : 0.01s CPU 0.01s WALL ( 73 calls) Called by h_psi: add_vuspsi : 0.00s CPU 0.00s WALL ( 81 calls) General routines calbec : 0.01s CPU 0.04s WALL ( 81 calls) fft : 0.25s CPU 0.61s WALL ( 93 calls) ffts : 2.91s CPU 5.45s WALL ( 1136 calls) fftw : 1.64s CPU 3.73s WALL ( 960 calls) davcio : 0.00s CPU 0.00s WALL ( 24 calls) Parallel routines fft_scatter : 1.40s CPU 2.29s WALL ( 2189 calls) EXX routines exx_grid : 0.00s CPU 0.00s WALL ( 1 calls) exxinit : 0.16s CPU 0.36s WALL ( 8 calls) vexx : 4.57s CPU 7.52s WALL ( 60 calls) exxen2 : 1.09s CPU 3.86s WALL ( 25 calls) PWSCF : 7.38s CPU 14.47s WALL This run was terminated on: 16:53: 9 14Dec2011 =------------------------------------------------------------------------------= JOB DONE. =------------------------------------------------------------------------------= TDDFPT/Examples/CH4-TDHF/CH4.tddfpt-ref0000644000175000017500000250775212341371500015357 0ustar mbamba Program TDDFPT v.4.3.2 starts on 14Dec2011 at 16:55:22 This program is part of the open-source Quantum ESPRESSO suite for quantum simulation of materials; please cite "P. Giannozzi et al., J. Phys.:Condens. Matter 21 395502 (2009); URL http://www.quantum-espresso.org", in publications or presentations arising from this work. More details at http://www.quantum-espresso.org/quote.php Parallel version (MPI), running on 4 processors R & G space division: proc/pool = 4 ---------------------------------------- This is TDDFPT (Time Dependent Density Functional Perturbation Theory) Sub Version: 0.9 ---------------------------------------- Ultrasoft (Vanderbilt) Pseudopotentials Info: using nr1, nr2, nr3 values from input Info: using nr1s, nr2s, nr3s values from input IMPORTANT: XC functional enforced from input : Exchange-correlation = HF ( 5 0 0 0 0) EXX-fraction = 1.00 Any further DFT definition will be discarded Please, verify this is what you really want file H.pz-vbc.UPF: wavefunction(s) 1S renormalized Parallelization info -------------------- sticks: dense smooth PW G-vecs: dense smooth PW Min 445 445 108 14262 14262 1776 Max 452 452 110 14264 14264 1783 Sum 1789 1789 437 57051 57051 7123 Tot 895 895 219 IMPORTANT: XC functional enforced from input : Exchange-correlation = HF ( 5 0 0 0 0) EXX-fraction = 1.00 Any further DFT definition will be discarded Please, verify this is what you really want EXX fraction changed: 1.00 EXX Screening parameter changed: 0.0000000 Subspace diagonalization in iterative solution of the eigenvalue problem: a serial algorithm will be used Lanczos linear response spectrum calculation Number of Lanczos iterations = 500 Gamma point algorithm Is it hybrid? T Is it hybrid? T Is it hybrid? T Is it hybrid? T hf commutator NOT used hf commutator NOT used hf commutator NOT used lr_wfcinit_spectrum: finished lr_solve_e Norm of initial Lanczos vectors= 0.939778515381034 Starting Lanczos loop 1 Lanczos iteration: 1 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal alpha(00000001)=0.000000000000000E+00 beta (00000002)=0.199314489592837E+01 gamma(00000002)=0.199314489592837E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 2 z1= 1 0.629699439613743E+00 0.000000000000000E+00 z1= 2 -.790043173503480E-07 0.000000000000000E+00 z1= 3 -.391051584690272E-08 0.000000000000000E+00 alpha(00000002)=0.000000000000000E+00 beta (00000003)=0.670063390421906E+01 gamma(00000003)=0.670063390421906E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 3 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000003)=0.000000000000000E+00 beta (00000004)=0.145136710095232E+02 gamma(00000004)=0.145136710095232E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 4 z1= 1 -.232649452883497E+00 0.000000000000000E+00 z1= 2 0.445986244668791E-07 0.000000000000000E+00 z1= 3 0.826739237637895E-08 0.000000000000000E+00 alpha(00000004)=0.000000000000000E+00 beta (00000005)=0.122818116856415E+02 gamma(00000005)=0.122818116856415E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 5 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000005)=0.000000000000000E+00 beta (00000006)=0.140748544373869E+02 gamma(00000006)=0.140748544373869E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 6 z1= 1 0.180583073815305E+00 0.000000000000000E+00 z1= 2 -.355825693415177E-07 0.000000000000000E+00 z1= 3 -.360429569979011E-08 0.000000000000000E+00 alpha(00000006)=0.000000000000000E+00 beta (00000007)=0.125865097471436E+02 gamma(00000007)=0.125865097471436E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 7 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000007)=0.000000000000000E+00 beta (00000008)=0.137410811316433E+02 gamma(00000008)=0.137410811316433E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 8 z1= 1 -.152686453137439E+00 0.000000000000000E+00 z1= 2 0.310629309991164E-07 0.000000000000000E+00 z1= 3 -.615582310169518E-09 0.000000000000000E+00 alpha(00000008)=0.000000000000000E+00 beta (00000009)=0.127728835063955E+02 gamma(00000009)=0.127728835063955E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 9 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000009)=0.000000000000000E+00 beta (00000010)=0.137004286105118E+02 gamma(00000010)=0.137004286105118E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 10 z1= 1 0.134159731582061E+00 0.000000000000000E+00 z1= 2 -.286374995470823E-07 0.000000000000000E+00 z1= 3 0.718047498933852E-08 0.000000000000000E+00 alpha(00000010)=0.000000000000000E+00 beta (00000011)=0.128681730902516E+02 gamma(00000011)=0.128681730902516E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 11 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000011)=0.000000000000000E+00 beta (00000012)=0.137106682879872E+02 gamma(00000012)=0.137106682879872E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 12 z1= 1 -.119965519020633E+00 0.000000000000000E+00 z1= 2 0.280328693418042E-07 0.000000000000000E+00 z1= 3 -.150790736138870E-07 0.000000000000000E+00 alpha(00000012)=0.000000000000000E+00 beta (00000013)=0.128417719253978E+02 gamma(00000013)=0.128417719253978E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 13 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000013)=0.000000000000000E+00 beta (00000014)=0.137011502445736E+02 gamma(00000014)=0.137011502445736E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 14 z1= 1 0.107900586012039E+00 0.000000000000000E+00 z1= 2 -.289744837367670E-07 0.000000000000000E+00 z1= 3 0.237499636248761E-07 0.000000000000000E+00 alpha(00000014)=0.000000000000000E+00 beta (00000015)=0.128940315845827E+02 gamma(00000015)=0.128940315845827E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 15 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000015)=0.000000000000000E+00 beta (00000016)=0.137440775865674E+02 gamma(00000016)=0.137440775865674E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 16 z1= 1 -.976649703633171E-01 0.000000000000000E+00 z1= 2 0.309641325947629E-07 0.000000000000000E+00 z1= 3 -.315985836227186E-07 0.000000000000000E+00 alpha(00000016)=0.000000000000000E+00 beta (00000017)=0.128587732247976E+02 gamma(00000017)=0.128587732247976E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 17 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000017)=0.000000000000000E+00 beta (00000018)=0.135691719987988E+02 gamma(00000018)=0.135691719987988E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 18 z1= 1 0.896249418398553E-01 0.000000000000000E+00 z1= 2 -.342386365917088E-07 0.000000000000000E+00 z1= 3 0.386880527212998E-07 0.000000000000000E+00 alpha(00000018)=0.000000000000000E+00 beta (00000019)=0.127885919895851E+02 gamma(00000019)=0.127885919895851E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 19 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000019)=0.000000000000000E+00 beta (00000020)=0.135638220895097E+02 gamma(00000020)=0.135638220895097E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 20 z1= 1 -.821470507592187E-01 0.000000000000000E+00 z1= 2 0.372473302132081E-07 0.000000000000000E+00 z1= 3 -.437973592436539E-07 0.000000000000000E+00 alpha(00000020)=0.000000000000000E+00 beta (00000021)=0.128362049127766E+02 gamma(00000021)=0.128362049127766E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 21 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000021)=0.000000000000000E+00 beta (00000022)=0.136591760395955E+02 gamma(00000022)=0.136591760395955E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 22 z1= 1 0.752871846196342E-01 0.000000000000000E+00 z1= 2 -.395616235361607E-07 0.000000000000000E+00 z1= 3 0.467938082290755E-07 0.000000000000000E+00 alpha(00000022)=0.000000000000000E+00 beta (00000023)=0.129862392183908E+02 gamma(00000023)=0.129862392183908E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 23 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000023)=0.000000000000000E+00 beta (00000024)=0.134425185951214E+02 gamma(00000024)=0.134425185951214E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 24 z1= 1 -.711507239952477E-01 0.000000000000000E+00 z1= 2 0.422118041458475E-07 0.000000000000000E+00 z1= 3 -.498774241821515E-07 0.000000000000000E+00 alpha(00000024)=0.000000000000000E+00 beta (00000025)=0.126824223268667E+02 gamma(00000025)=0.126824223268667E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 25 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000025)=0.000000000000000E+00 beta (00000026)=0.137714874274684E+02 gamma(00000026)=0.137714874274684E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 26 z1= 1 0.642710264558193E-01 0.000000000000000E+00 z1= 2 -.425410468744142E-07 0.000000000000000E+00 z1= 3 0.491429920181953E-07 0.000000000000000E+00 alpha(00000026)=0.000000000000000E+00 beta (00000027)=0.130491945373726E+02 gamma(00000027)=0.130491945373726E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 27 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000027)=0.000000000000000E+00 beta (00000028)=0.135068048556253E+02 gamma(00000028)=0.135068048556253E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 28 z1= 1 -.610286306267775E-01 0.000000000000000E+00 z1= 2 0.448795141449326E-07 0.000000000000000E+00 z1= 3 -.503452167453550E-07 0.000000000000000E+00 alpha(00000028)=0.000000000000000E+00 beta (00000029)=0.130079375391233E+02 gamma(00000029)=0.130079375391233E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 29 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000029)=0.000000000000000E+00 beta (00000030)=0.137016561421765E+02 gamma(00000030)=0.137016561421765E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 30 z1= 1 0.570655570897787E-01 0.000000000000000E+00 z1= 2 -.474683821260341E-07 0.000000000000000E+00 z1= 3 0.506427640022621E-07 0.000000000000000E+00 alpha(00000030)=0.000000000000000E+00 beta (00000031)=0.128552406851466E+02 gamma(00000031)=0.128552406851466E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 31 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000031)=0.000000000000000E+00 beta (00000032)=0.135894771756973E+02 gamma(00000032)=0.135894771756973E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 32 z1= 1 -.532519442867470E-01 0.000000000000000E+00 z1= 2 0.516285093583174E-07 0.000000000000000E+00 z1= 3 -.510061676389263E-07 0.000000000000000E+00 alpha(00000032)=0.000000000000000E+00 beta (00000033)=0.128204748039437E+02 gamma(00000033)=0.128204748039437E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 33 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000033)=0.000000000000000E+00 beta (00000034)=0.137184811448286E+02 gamma(00000034)=0.137184811448286E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 34 z1= 1 0.491435220518670E-01 0.000000000000000E+00 z1= 2 -.563259738156630E-07 0.000000000000000E+00 z1= 3 0.511742166600226E-07 0.000000000000000E+00 alpha(00000034)=0.000000000000000E+00 beta (00000035)=0.126970623820303E+02 gamma(00000035)=0.126970623820303E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 35 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000035)=0.000000000000000E+00 beta (00000036)=0.133797814887204E+02 gamma(00000036)=0.133797814887204E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 36 z1= 1 -.460174241343410E-01 0.000000000000000E+00 z1= 2 0.640056071025963E-07 0.000000000000000E+00 z1= 3 -.529524175089599E-07 0.000000000000000E+00 alpha(00000036)=0.000000000000000E+00 beta (00000037)=0.129598322258005E+02 gamma(00000037)=0.129598322258005E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 37 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000037)=0.000000000000000E+00 beta (00000038)=0.134637158827624E+02 gamma(00000038)=0.134637158827624E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 38 z1= 1 0.437620187036991E-01 0.000000000000000E+00 z1= 2 -.734833097426613E-07 0.000000000000000E+00 z1= 3 0.565441653044112E-07 0.000000000000000E+00 alpha(00000038)=0.000000000000000E+00 beta (00000039)=0.129519596054363E+02 gamma(00000039)=0.129519596054363E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 39 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000039)=0.000000000000000E+00 beta (00000040)=0.134361828477707E+02 gamma(00000040)=0.134361828477707E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 40 z1= 1 -.417117613235536E-01 0.000000000000000E+00 z1= 2 0.836454415818061E-07 0.000000000000000E+00 z1= 3 -.605894635401227E-07 0.000000000000000E+00 alpha(00000040)=0.000000000000000E+00 beta (00000041)=0.128131234187460E+02 gamma(00000041)=0.128131234187460E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 41 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000041)=0.000000000000000E+00 beta (00000042)=0.136904438780917E+02 gamma(00000042)=0.136904438780917E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 42 z1= 1 0.385860355158934E-01 0.000000000000000E+00 z1= 2 -.916977641474831E-07 0.000000000000000E+00 z1= 3 0.625085514356638E-07 0.000000000000000E+00 alpha(00000042)=0.000000000000000E+00 beta (00000043)=0.127838997798536E+02 gamma(00000043)=0.127838997798536E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 43 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000043)=0.000000000000000E+00 beta (00000044)=0.135912146131949E+02 gamma(00000044)=0.135912146131949E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 44 z1= 1 -.358747495111304E-01 0.000000000000000E+00 z1= 2 0.995511434329077E-07 0.000000000000000E+00 z1= 3 -.653873305144978E-07 0.000000000000000E+00 alpha(00000044)=0.000000000000000E+00 beta (00000045)=0.125361796337573E+02 gamma(00000045)=0.125361796337573E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 45 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000045)=0.000000000000000E+00 beta (00000046)=0.133760152247604E+02 gamma(00000046)=0.133760152247604E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 46 z1= 1 0.331847081691373E-01 0.000000000000000E+00 z1= 2 -.106153923061514E-06 0.000000000000000E+00 z1= 3 0.687936729652262E-07 0.000000000000000E+00 alpha(00000046)=0.000000000000000E+00 beta (00000047)=0.125069520763261E+02 gamma(00000047)=0.125069520763261E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 47 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000047)=0.000000000000000E+00 beta (00000048)=0.136080032283463E+02 gamma(00000048)=0.136080032283463E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 48 z1= 1 -.300255652999202E-01 0.000000000000000E+00 z1= 2 0.109308314017419E-06 0.000000000000000E+00 z1= 3 -.708681219630056E-07 0.000000000000000E+00 alpha(00000048)=0.000000000000000E+00 beta (00000049)=0.131223666203520E+02 gamma(00000049)=0.131223666203520E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 49 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000049)=0.000000000000000E+00 beta (00000050)=0.138460115260009E+02 gamma(00000050)=0.138460115260009E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 50 z1= 1 0.280696819284854E-01 0.000000000000000E+00 z1= 2 -.114052812776565E-06 0.000000000000000E+00 z1= 3 0.747677241640533E-07 0.000000000000000E+00 alpha(00000050)=0.000000000000000E+00 beta (00000051)=0.127731414632389E+02 gamma(00000051)=0.127731414632389E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 51 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000051)=0.000000000000000E+00 beta (00000052)=0.133798771920598E+02 gamma(00000052)=0.133798771920598E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 52 z1= 1 -.264229067878593E-01 0.000000000000000E+00 z1= 2 0.118722932651583E-06 0.000000000000000E+00 z1= 3 -.788286759563408E-07 0.000000000000000E+00 alpha(00000052)=0.000000000000000E+00 beta (00000053)=0.126315029408539E+02 gamma(00000053)=0.126315029408539E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 53 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000053)=0.000000000000000E+00 beta (00000054)=0.132873849875523E+02 gamma(00000054)=0.132873849875523E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 54 z1= 1 0.247455242610410E-01 0.000000000000000E+00 z1= 2 -.120483196166393E-06 0.000000000000000E+00 z1= 3 0.817407086371952E-07 0.000000000000000E+00 alpha(00000054)=0.000000000000000E+00 beta (00000055)=0.133543423308200E+02 gamma(00000055)=0.133543423308200E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 55 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000055)=0.000000000000000E+00 beta (00000056)=0.135611657899949E+02 gamma(00000056)=0.135611657899949E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 56 z1= 1 -.240546084955883E-01 0.000000000000000E+00 z1= 2 0.125918631533814E-06 0.000000000000000E+00 z1= 3 -.874426235228636E-07 0.000000000000000E+00 alpha(00000056)=0.000000000000000E+00 beta (00000057)=0.131772739525330E+02 gamma(00000057)=0.131772739525330E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 57 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000057)=0.000000000000000E+00 beta (00000058)=0.132235070573977E+02 gamma(00000058)=0.132235070573977E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 58 z1= 1 0.236685769617261E-01 0.000000000000000E+00 z1= 2 -.132952548809705E-06 0.000000000000000E+00 z1= 3 0.944230727269874E-07 0.000000000000000E+00 alpha(00000058)=0.000000000000000E+00 beta (00000059)=0.127640921907535E+02 gamma(00000059)=0.127640921907535E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 59 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000059)=0.000000000000000E+00 beta (00000060)=0.136257177619250E+02 gamma(00000060)=0.136257177619250E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 60 z1= 1 -.218999050799903E-01 0.000000000000000E+00 z1= 2 0.130029053271169E-06 0.000000000000000E+00 z1= 3 -.953795879980561E-07 0.000000000000000E+00 alpha(00000060)=0.000000000000000E+00 beta (00000061)=0.132790722464662E+02 gamma(00000061)=0.132790722464662E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 61 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000061)=0.000000000000000E+00 beta (00000062)=0.139030699517365E+02 gamma(00000062)=0.139030699517365E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 62 z1= 1 0.206469522154024E-01 0.000000000000000E+00 z1= 2 -.129120442834280E-06 0.000000000000000E+00 z1= 3 0.982384213625391E-07 0.000000000000000E+00 alpha(00000062)=0.000000000000000E+00 beta (00000063)=0.131183044917284E+02 gamma(00000063)=0.131183044917284E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 63 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000063)=0.000000000000000E+00 beta (00000064)=0.135405057431563E+02 gamma(00000064)=0.135405057431563E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 64 z1= 1 -.197046339399251E-01 0.000000000000000E+00 z1= 2 0.130009286059864E-06 0.000000000000000E+00 z1= 3 -.103068107184059E-06 0.000000000000000E+00 alpha(00000064)=0.000000000000000E+00 beta (00000065)=0.125391282389017E+02 gamma(00000065)=0.125391282389017E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 65 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000065)=0.000000000000000E+00 beta (00000066)=0.134390294118537E+02 gamma(00000066)=0.134390294118537E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 66 z1= 1 0.181131008367128E-01 0.000000000000000E+00 z1= 2 -.126822318301592E-06 0.000000000000000E+00 z1= 3 0.104784210718293E-06 0.000000000000000E+00 alpha(00000066)=0.000000000000000E+00 beta (00000067)=0.132140245025298E+02 gamma(00000067)=0.132140245025298E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 67 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000067)=0.000000000000000E+00 beta (00000068)=0.138620823529641E+02 gamma(00000068)=0.138620823529641E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 68 z1= 1 -.171057515574852E-01 0.000000000000000E+00 z1= 2 0.126707953877411E-06 0.000000000000000E+00 z1= 3 -.107798073352688E-06 0.000000000000000E+00 alpha(00000068)=0.000000000000000E+00 beta (00000069)=0.130348418652423E+02 gamma(00000069)=0.130348418652423E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 69 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000069)=0.000000000000000E+00 beta (00000070)=0.133201125052975E+02 gamma(00000070)=0.133201125052975E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 70 z1= 1 0.165989918357651E-01 0.000000000000000E+00 z1= 2 -.130482979318960E-06 0.000000000000000E+00 z1= 3 0.114328544108320E-06 0.000000000000000E+00 alpha(00000070)=0.000000000000000E+00 beta (00000071)=0.128104083168195E+02 gamma(00000071)=0.128104083168195E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 71 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000071)=0.000000000000000E+00 beta (00000072)=0.139896032874501E+02 gamma(00000072)=0.139896032874501E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 72 z1= 1 -.150836833098314E-01 0.000000000000000E+00 z1= 2 0.126359305916215E-06 0.000000000000000E+00 z1= 3 -.113926886278386E-06 0.000000000000000E+00 alpha(00000072)=0.000000000000000E+00 beta (00000073)=0.128218322672780E+02 gamma(00000073)=0.128218322672780E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 73 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000073)=0.000000000000000E+00 beta (00000074)=0.132875910550026E+02 gamma(00000074)=0.132875910550026E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 74 z1= 1 0.144443738132464E-01 0.000000000000000E+00 z1= 2 -.129056274208138E-06 0.000000000000000E+00 z1= 3 0.119916623525810E-06 0.000000000000000E+00 alpha(00000074)=0.000000000000000E+00 beta (00000075)=0.122804831444376E+02 gamma(00000075)=0.122804831444376E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 75 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000075)=0.000000000000000E+00 beta (00000076)=0.134548957386817E+02 gamma(00000076)=0.134548957386817E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 76 z1= 1 -.131039011002168E-01 0.000000000000000E+00 z1= 2 0.125843071538054E-06 0.000000000000000E+00 z1= 3 -.119856227001765E-06 0.000000000000000E+00 alpha(00000076)=0.000000000000000E+00 beta (00000077)=0.128673825058667E+02 gamma(00000077)=0.128673825058667E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 77 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000077)=0.000000000000000E+00 beta (00000078)=0.139740047994397E+02 gamma(00000078)=0.139740047994397E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 78 z1= 1 0.120552354837012E-01 0.000000000000000E+00 z1= 2 -.124244844224323E-06 0.000000000000000E+00 z1= 3 0.121749469763547E-06 0.000000000000000E+00 alpha(00000078)=0.000000000000000E+00 beta (00000079)=0.127688478497266E+02 gamma(00000079)=0.127688478497266E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 79 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000079)=0.000000000000000E+00 beta (00000080)=0.134060378904716E+02 gamma(00000080)=0.134060378904716E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 80 z1= 1 -.115191256856602E-01 0.000000000000000E+00 z1= 2 0.126945193342030E-06 0.000000000000000E+00 z1= 3 -.128764466214462E-06 0.000000000000000E+00 alpha(00000080)=0.000000000000000E+00 beta (00000081)=0.127014913153587E+02 gamma(00000081)=0.127014913153587E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 81 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000081)=0.000000000000000E+00 beta (00000082)=0.140476867555164E+02 gamma(00000082)=0.140476867555164E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 82 z1= 1 0.104894604823772E-01 0.000000000000000E+00 z1= 2 -.123596700209302E-06 0.000000000000000E+00 z1= 3 0.128566165001447E-06 0.000000000000000E+00 alpha(00000082)=0.000000000000000E+00 beta (00000083)=0.128227081396660E+02 gamma(00000083)=0.128227081396660E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 83 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000083)=0.000000000000000E+00 beta (00000084)=0.131465154516548E+02 gamma(00000084)=0.131465154516548E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 84 z1= 1 -.103253646718334E-01 0.000000000000000E+00 z1= 2 0.130834988616973E-06 0.000000000000000E+00 z1= 3 -.138065766758363E-06 0.000000000000000E+00 alpha(00000084)=0.000000000000000E+00 beta (00000085)=0.129169616482729E+02 gamma(00000085)=0.129169616482729E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 85 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000085)=0.000000000000000E+00 beta (00000086)=0.141724385169611E+02 gamma(00000086)=0.141724385169611E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 86 z1= 1 0.937914782975222E-02 0.000000000000000E+00 z1= 2 -.129308168104721E-06 0.000000000000000E+00 z1= 3 0.137531514950422E-06 0.000000000000000E+00 alpha(00000086)=0.000000000000000E+00 beta (00000087)=0.126042116936391E+02 gamma(00000087)=0.126042116936391E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 87 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000087)=0.000000000000000E+00 beta (00000088)=0.133572271952497E+02 gamma(00000088)=0.133572271952497E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 88 z1= 1 -.866887342982982E-02 0.000000000000000E+00 z1= 2 0.135817714401682E-06 0.000000000000000E+00 z1= 3 -.143835750764250E-06 0.000000000000000E+00 alpha(00000088)=0.000000000000000E+00 beta (00000089)=0.129319535091820E+02 gamma(00000089)=0.129319535091820E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 89 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000089)=0.000000000000000E+00 beta (00000090)=0.137666362789426E+02 gamma(00000090)=0.137666362789426E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 90 z1= 1 0.790768219910548E-02 0.000000000000000E+00 z1= 2 -.140317047832034E-06 0.000000000000000E+00 z1= 3 0.148548850518364E-06 0.000000000000000E+00 alpha(00000090)=0.000000000000000E+00 beta (00000091)=0.125045600113663E+02 gamma(00000091)=0.125045600113663E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 91 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000091)=0.000000000000000E+00 beta (00000092)=0.129404263603306E+02 gamma(00000092)=0.129404263603306E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 92 z1= 1 -.741078138394085E-02 0.000000000000000E+00 z1= 2 0.149268604875390E-06 0.000000000000000E+00 z1= 3 -.158878478403839E-06 0.000000000000000E+00 alpha(00000092)=0.000000000000000E+00 beta (00000093)=0.134311014623322E+02 gamma(00000093)=0.134311014623322E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 93 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000093)=0.000000000000000E+00 beta (00000094)=0.132437626697703E+02 gamma(00000094)=0.132437626697703E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 94 z1= 1 0.733577632193883E-02 0.000000000000000E+00 z1= 2 -.163993057578950E-06 0.000000000000000E+00 z1= 3 0.174813724390416E-06 0.000000000000000E+00 alpha(00000094)=0.000000000000000E+00 beta (00000095)=0.124429521247612E+02 gamma(00000095)=0.124429521247612E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 95 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000095)=0.000000000000000E+00 beta (00000096)=0.130304932901143E+02 gamma(00000096)=0.130304932901143E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 96 z1= 1 -.684846527500056E-02 0.000000000000000E+00 z1= 2 0.170226386828846E-06 0.000000000000000E+00 z1= 3 -.181302070358016E-06 0.000000000000000E+00 alpha(00000096)=0.000000000000000E+00 beta (00000097)=0.127892154763279E+02 gamma(00000097)=0.127892154763279E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 97 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000097)=0.000000000000000E+00 beta (00000098)=0.128270162451482E+02 gamma(00000098)=0.128270162451482E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 98 z1= 1 0.663201912279861E-02 0.000000000000000E+00 z1= 2 -.184048921010984E-06 0.000000000000000E+00 z1= 3 0.195546548190529E-06 0.000000000000000E+00 alpha(00000098)=0.000000000000000E+00 beta (00000099)=0.121409212424552E+02 gamma(00000099)=0.121409212424552E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 99 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000099)=0.000000000000000E+00 beta (00000100)=0.136038282484082E+02 gamma(00000100)=0.136038282484082E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 100 z1= 1 -.578328407467178E-02 0.000000000000000E+00 z1= 2 0.178034166451770E-06 0.000000000000000E+00 z1= 3 -.187144844871140E-06 0.000000000000000E+00 alpha(00000100)=0.000000000000000E+00 beta (00000101)=0.129656537131500E+02 gamma(00000101)=0.129656537131500E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 101 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000101)=0.000000000000000E+00 beta (00000102)=0.131118296298006E+02 gamma(00000102)=0.131118296298006E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 102 z1= 1 0.575067751371675E-02 0.000000000000000E+00 z1= 2 -.192620160498029E-06 0.000000000000000E+00 z1= 3 0.197018797848869E-06 0.000000000000000E+00 alpha(00000102)=0.000000000000000E+00 beta (00000103)=0.136938619400343E+02 gamma(00000103)=0.136938619400343E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 103 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000103)=0.000000000000000E+00 beta (00000104)=0.133882020471619E+02 gamma(00000104)=0.133882020471619E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 104 z1= 1 -.609538610441336E-02 0.000000000000000E+00 z1= 2 0.213574171553828E-06 0.000000000000000E+00 z1= 3 -.211270382169902E-06 0.000000000000000E+00 alpha(00000104)=0.000000000000000E+00 beta (00000105)=0.130441734932393E+02 gamma(00000105)=0.130441734932393E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 105 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000105)=0.000000000000000E+00 beta (00000106)=0.141232678290096E+02 gamma(00000106)=0.141232678290096E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 106 z1= 1 0.588737167301560E-02 0.000000000000000E+00 z1= 2 -.213462623711684E-06 0.000000000000000E+00 z1= 3 0.204595209748920E-06 0.000000000000000E+00 alpha(00000106)=0.000000000000000E+00 beta (00000107)=0.131966683974343E+02 gamma(00000107)=0.131966683974343E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 107 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000107)=0.000000000000000E+00 beta (00000108)=0.134607526403257E+02 gamma(00000108)=0.134607526403257E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 108 z1= 1 -.602258864379268E-02 0.000000000000000E+00 z1= 2 0.226762266563978E-06 0.000000000000000E+00 z1= 3 -.211036731536122E-06 0.000000000000000E+00 alpha(00000108)=0.000000000000000E+00 beta (00000109)=0.135930230591445E+02 gamma(00000109)=0.135930230591445E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 109 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000109)=0.000000000000000E+00 beta (00000110)=0.125435606231473E+02 gamma(00000110)=0.125435606231473E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 110 z1= 1 0.671348031256925E-02 0.000000000000000E+00 z1= 2 -.262897944901166E-06 0.000000000000000E+00 z1= 3 0.239730208327583E-06 0.000000000000000E+00 alpha(00000110)=0.000000000000000E+00 beta (00000111)=0.131064307120009E+02 gamma(00000111)=0.131064307120009E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 111 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000111)=0.000000000000000E+00 beta (00000112)=0.137148872541247E+02 gamma(00000112)=0.137148872541247E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 112 z1= 1 -.655037815193507E-02 0.000000000000000E+00 z1= 2 0.265770899398297E-06 0.000000000000000E+00 z1= 3 -.238150252587451E-06 0.000000000000000E+00 alpha(00000112)=0.000000000000000E+00 beta (00000113)=0.127404522925120E+02 gamma(00000113)=0.127404522925120E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 113 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000113)=0.000000000000000E+00 beta (00000114)=0.137207992548290E+02 gamma(00000114)=0.137207992548290E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 114 z1= 1 0.624095907950348E-02 0.000000000000000E+00 z1= 2 -.260549179395184E-06 0.000000000000000E+00 z1= 3 0.228584554573893E-06 0.000000000000000E+00 alpha(00000114)=0.000000000000000E+00 beta (00000115)=0.119984404345280E+02 gamma(00000115)=0.119984404345280E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 115 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000115)=0.000000000000000E+00 beta (00000116)=0.137000640069187E+02 gamma(00000116)=0.137000640069187E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 116 z1= 1 -.572372627041975E-02 0.000000000000000E+00 z1= 2 0.242585008041157E-06 0.000000000000000E+00 z1= 3 -.208119080672754E-06 0.000000000000000E+00 alpha(00000116)=0.000000000000000E+00 beta (00000117)=0.124256703779944E+02 gamma(00000117)=0.124256703779944E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 117 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000117)=0.000000000000000E+00 beta (00000118)=0.134796471024205E+02 gamma(00000118)=0.134796471024205E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 118 z1= 1 0.548265894666256E-02 0.000000000000000E+00 z1= 2 -.237591680507694E-06 0.000000000000000E+00 z1= 3 0.200223550136063E-06 0.000000000000000E+00 alpha(00000118)=0.000000000000000E+00 beta (00000119)=0.128590935355193E+02 gamma(00000119)=0.128590935355193E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 119 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000119)=0.000000000000000E+00 beta (00000120)=0.134053479215270E+02 gamma(00000120)=0.134053479215270E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 120 z1= 1 -.535943005066476E-02 0.000000000000000E+00 z1= 2 0.240098496958729E-06 0.000000000000000E+00 z1= 3 -.199551811298250E-06 0.000000000000000E+00 alpha(00000120)=0.000000000000000E+00 beta (00000121)=0.127605140356481E+02 gamma(00000121)=0.127605140356481E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 121 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000121)=0.000000000000000E+00 beta (00000122)=0.133447991816347E+02 gamma(00000122)=0.133447991816347E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 122 z1= 1 0.514308602099111E-02 0.000000000000000E+00 z1= 2 -.241217581659937E-06 0.000000000000000E+00 z1= 3 0.197687625185048E-06 0.000000000000000E+00 alpha(00000122)=0.000000000000000E+00 beta (00000123)=0.127224548761476E+02 gamma(00000123)=0.127224548761476E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 123 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000123)=0.000000000000000E+00 beta (00000124)=0.134570338721770E+02 gamma(00000124)=0.134570338721770E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 124 z1= 1 -.484971041775950E-02 0.000000000000000E+00 z1= 2 0.239250138868788E-06 0.000000000000000E+00 z1= 3 -.192957968902325E-06 0.000000000000000E+00 alpha(00000124)=0.000000000000000E+00 beta (00000125)=0.129005355771432E+02 gamma(00000125)=0.129005355771432E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 125 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000125)=0.000000000000000E+00 beta (00000126)=0.137360704794920E+02 gamma(00000126)=0.137360704794920E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 126 z1= 1 0.460509535277043E-02 0.000000000000000E+00 z1= 2 -.236018667591591E-06 0.000000000000000E+00 z1= 3 0.187331902926600E-06 0.000000000000000E+00 alpha(00000126)=0.000000000000000E+00 beta (00000127)=0.128192898108233E+02 gamma(00000127)=0.128192898108233E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 127 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000127)=0.000000000000000E+00 beta (00000128)=0.138278604915789E+02 gamma(00000128)=0.138278604915789E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 128 z1= 1 -.438245497233934E-02 0.000000000000000E+00 z1= 2 0.228858828313708E-06 0.000000000000000E+00 z1= 3 -.179518824544578E-06 0.000000000000000E+00 alpha(00000128)=0.000000000000000E+00 beta (00000129)=0.132954719200699E+02 gamma(00000129)=0.132954719200699E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 129 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000129)=0.000000000000000E+00 beta (00000130)=0.135447773318209E+02 gamma(00000130)=0.135447773318209E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 130 z1= 1 0.440975981158742E-02 0.000000000000000E+00 z1= 2 -.233570926967686E-06 0.000000000000000E+00 z1= 3 0.181833708330647E-06 0.000000000000000E+00 alpha(00000130)=0.000000000000000E+00 beta (00000131)=0.125749778195061E+02 gamma(00000131)=0.125749778195061E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 131 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000131)=0.000000000000000E+00 beta (00000132)=0.135691626600368E+02 gamma(00000132)=0.135691626600368E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 132 z1= 1 -.410269785692999E-02 0.000000000000000E+00 z1= 2 0.225224090407219E-06 0.000000000000000E+00 z1= 3 -.175186824126472E-06 0.000000000000000E+00 alpha(00000132)=0.000000000000000E+00 beta (00000133)=0.125411204807362E+02 gamma(00000133)=0.125411204807362E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 133 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000133)=0.000000000000000E+00 beta (00000134)=0.135110526921423E+02 gamma(00000134)=0.135110526921423E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 134 z1= 1 0.375442099112211E-02 0.000000000000000E+00 z1= 2 -.217979579217494E-06 0.000000000000000E+00 z1= 3 0.169706446510561E-06 0.000000000000000E+00 alpha(00000134)=0.000000000000000E+00 beta (00000135)=0.127015234559974E+02 gamma(00000135)=0.127015234559974E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 135 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000135)=0.000000000000000E+00 beta (00000136)=0.137731859990845E+02 gamma(00000136)=0.137731859990845E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 136 z1= 1 -.336089218040694E-02 0.000000000000000E+00 z1= 2 0.209866906689810E-06 0.000000000000000E+00 z1= 3 -.163128470334378E-06 0.000000000000000E+00 alpha(00000136)=0.000000000000000E+00 beta (00000137)=0.127543165887841E+02 gamma(00000137)=0.127543165887841E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 137 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000137)=0.000000000000000E+00 beta (00000138)=0.130998877886756E+02 gamma(00000138)=0.130998877886756E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 138 z1= 1 0.320289220220138E-02 0.000000000000000E+00 z1= 2 -.212089571754830E-06 0.000000000000000E+00 z1= 3 0.165361267807549E-06 0.000000000000000E+00 alpha(00000138)=0.000000000000000E+00 beta (00000139)=0.124440191158503E+02 gamma(00000139)=0.124440191158503E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 139 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000139)=0.000000000000000E+00 beta (00000140)=0.138474360319970E+02 gamma(00000140)=0.138474360319970E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 140 z1= 1 -.293330042571033E-02 0.000000000000000E+00 z1= 2 0.198984612903227E-06 0.000000000000000E+00 z1= 3 -.154973516855493E-06 0.000000000000000E+00 alpha(00000140)=0.000000000000000E+00 beta (00000141)=0.131458636091220E+02 gamma(00000141)=0.131458636091220E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 141 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000141)=0.000000000000000E+00 beta (00000142)=0.135271025741067E+02 gamma(00000142)=0.135271025741067E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 142 z1= 1 0.300420298387693E-02 0.000000000000000E+00 z1= 2 -.202662758849899E-06 0.000000000000000E+00 z1= 3 0.157858339033833E-06 0.000000000000000E+00 alpha(00000142)=0.000000000000000E+00 beta (00000143)=0.126296384563330E+02 gamma(00000143)=0.126296384563330E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 143 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000143)=0.000000000000000E+00 beta (00000144)=0.135905491599270E+02 gamma(00000144)=0.135905491599270E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 144 z1= 1 -.304595461568990E-02 0.000000000000000E+00 z1= 2 0.197481777584364E-06 0.000000000000000E+00 z1= 3 -.154377250518190E-06 0.000000000000000E+00 alpha(00000144)=0.000000000000000E+00 beta (00000145)=0.131395621172526E+02 gamma(00000145)=0.131395621172526E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 145 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000145)=0.000000000000000E+00 beta (00000146)=0.139085315853669E+02 gamma(00000146)=0.139085315853669E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 146 z1= 1 0.313635849522420E-02 0.000000000000000E+00 z1= 2 -.194824904227626E-06 0.000000000000000E+00 z1= 3 0.153547731059859E-06 0.000000000000000E+00 alpha(00000146)=0.000000000000000E+00 beta (00000147)=0.132398658126767E+02 gamma(00000147)=0.132398658126767E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 147 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000147)=0.000000000000000E+00 beta (00000148)=0.138453776145014E+02 gamma(00000148)=0.138453776145014E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 148 z1= 1 -.318852466311630E-02 0.000000000000000E+00 z1= 2 0.192281719703868E-06 0.000000000000000E+00 z1= 3 -.154963281717236E-06 0.000000000000000E+00 alpha(00000148)=0.000000000000000E+00 beta (00000149)=0.128467224861653E+02 gamma(00000149)=0.128467224861653E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 149 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000149)=0.000000000000000E+00 beta (00000150)=0.133348048194117E+02 gamma(00000150)=0.133348048194117E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 150 z1= 1 0.324331572590408E-02 0.000000000000000E+00 z1= 2 -.189788470816572E-06 0.000000000000000E+00 z1= 3 0.157961088061327E-06 0.000000000000000E+00 alpha(00000150)=0.000000000000000E+00 beta (00000151)=0.126505455581578E+02 gamma(00000151)=0.126505455581578E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 151 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000151)=0.000000000000000E+00 beta (00000152)=0.138852441783096E+02 gamma(00000152)=0.138852441783096E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 152 z1= 1 -.302715973716591E-02 0.000000000000000E+00 z1= 2 0.176214468455534E-06 0.000000000000000E+00 z1= 3 -.151737525634524E-06 0.000000000000000E+00 alpha(00000152)=0.000000000000000E+00 beta (00000153)=0.127834212130350E+02 gamma(00000153)=0.127834212130350E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 153 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000153)=0.000000000000000E+00 beta (00000154)=0.141175276807793E+02 gamma(00000154)=0.141175276807793E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 154 z1= 1 0.276120819958284E-02 0.000000000000000E+00 z1= 2 -.163439966828233E-06 0.000000000000000E+00 z1= 3 0.145305779758725E-06 0.000000000000000E+00 alpha(00000154)=0.000000000000000E+00 beta (00000155)=0.125123414167221E+02 gamma(00000155)=0.125123414167221E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 155 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000155)=0.000000000000000E+00 beta (00000156)=0.132693146785993E+02 gamma(00000156)=0.132693146785993E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 156 z1= 1 -.263255150573800E-02 0.000000000000000E+00 z1= 2 0.159923419120692E-06 0.000000000000000E+00 z1= 3 -.145891852567335E-06 0.000000000000000E+00 alpha(00000156)=0.000000000000000E+00 beta (00000157)=0.126048874929087E+02 gamma(00000157)=0.126048874929087E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 157 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000157)=0.000000000000000E+00 beta (00000158)=0.137949406913750E+02 gamma(00000158)=0.137949406913750E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 158 z1= 1 0.237107218865186E-02 0.000000000000000E+00 z1= 2 -.150772437901596E-06 0.000000000000000E+00 z1= 3 0.141268847002980E-06 0.000000000000000E+00 alpha(00000158)=0.000000000000000E+00 beta (00000159)=0.130584187323277E+02 gamma(00000159)=0.130584187323277E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 159 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000159)=0.000000000000000E+00 beta (00000160)=0.138031364552410E+02 gamma(00000160)=0.138031364552410E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 160 z1= 1 -.217735560559717E-02 0.000000000000000E+00 z1= 2 0.146221651282826E-06 0.000000000000000E+00 z1= 3 -.141976176984038E-06 0.000000000000000E+00 alpha(00000160)=0.000000000000000E+00 beta (00000161)=0.129234982289354E+02 gamma(00000161)=0.129234982289354E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 161 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000161)=0.000000000000000E+00 beta (00000162)=0.133298269372559E+02 gamma(00000162)=0.133298269372559E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 162 z1= 1 0.200133286575746E-02 0.000000000000000E+00 z1= 2 -.146003030388571E-06 0.000000000000000E+00 z1= 3 0.146422581953501E-06 0.000000000000000E+00 alpha(00000162)=0.000000000000000E+00 beta (00000163)=0.124682393156255E+02 gamma(00000163)=0.124682393156255E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 163 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000163)=0.000000000000000E+00 beta (00000164)=0.134658102188528E+02 gamma(00000164)=0.134658102188528E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 164 z1= 1 -.164561363511319E-02 0.000000000000000E+00 z1= 2 0.141400804012698E-06 0.000000000000000E+00 z1= 3 -.143878640364217E-06 0.000000000000000E+00 alpha(00000164)=0.000000000000000E+00 beta (00000165)=0.128624670105286E+02 gamma(00000165)=0.128624670105286E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 165 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000165)=0.000000000000000E+00 beta (00000166)=0.137346241573118E+02 gamma(00000166)=0.137346241573118E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 166 z1= 1 0.125850749776046E-02 0.000000000000000E+00 z1= 2 -.139600414210124E-06 0.000000000000000E+00 z1= 3 0.142576620010596E-06 0.000000000000000E+00 alpha(00000166)=0.000000000000000E+00 beta (00000167)=0.126784925637635E+02 gamma(00000167)=0.126784925637635E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 167 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000167)=0.000000000000000E+00 beta (00000168)=0.142370273170545E+02 gamma(00000168)=0.142370273170545E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 168 z1= 1 -.852431267030144E-03 0.000000000000000E+00 z1= 2 0.131601046807705E-06 0.000000000000000E+00 z1= 3 -.133843843027660E-06 0.000000000000000E+00 alpha(00000168)=0.000000000000000E+00 beta (00000169)=0.122884014968333E+02 gamma(00000169)=0.122884014968333E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 169 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000169)=0.000000000000000E+00 beta (00000170)=0.139332121799770E+02 gamma(00000170)=0.139332121799770E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 170 z1= 1 0.606214795225650E-03 0.000000000000000E+00 z1= 2 -.124751090381514E-06 0.000000000000000E+00 z1= 3 0.125017474307283E-06 0.000000000000000E+00 alpha(00000170)=0.000000000000000E+00 beta (00000171)=0.130755792432549E+02 gamma(00000171)=0.130755792432549E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 171 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000171)=0.000000000000000E+00 beta (00000172)=0.136261946696336E+02 gamma(00000172)=0.136261946696336E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 172 z1= 1 -.481823060410206E-03 0.000000000000000E+00 z1= 2 0.127738019802220E-06 0.000000000000000E+00 z1= 3 -.127344711010760E-06 0.000000000000000E+00 alpha(00000172)=0.000000000000000E+00 beta (00000173)=0.121894696499092E+02 gamma(00000173)=0.121894696499092E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 173 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000173)=0.000000000000000E+00 beta (00000174)=0.133774800139546E+02 gamma(00000174)=0.133774800139546E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 174 z1= 1 0.329048549510010E-03 0.000000000000000E+00 z1= 2 -.123461221634004E-06 0.000000000000000E+00 z1= 3 0.124347467996976E-06 0.000000000000000E+00 alpha(00000174)=0.000000000000000E+00 beta (00000175)=0.130321722603795E+02 gamma(00000175)=0.130321722603795E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 175 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000175)=0.000000000000000E+00 beta (00000176)=0.135964548509304E+02 gamma(00000176)=0.135964548509304E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 176 z1= 1 -.201469296339386E-03 0.000000000000000E+00 z1= 2 0.122631523445920E-06 0.000000000000000E+00 z1= 3 -.127447674756417E-06 0.000000000000000E+00 alpha(00000176)=0.000000000000000E+00 beta (00000177)=0.131049330920202E+02 gamma(00000177)=0.131049330920202E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 177 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000177)=0.000000000000000E+00 beta (00000178)=0.137484359070398E+02 gamma(00000178)=0.137484359070398E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 178 z1= 1 0.451987067503351E-04 0.000000000000000E+00 z1= 2 -.118885784591198E-06 0.000000000000000E+00 z1= 3 0.128334410936560E-06 0.000000000000000E+00 alpha(00000178)=0.000000000000000E+00 beta (00000179)=0.125767414999540E+02 gamma(00000179)=0.125767414999540E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 179 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000179)=0.000000000000000E+00 beta (00000180)=0.132901874385081E+02 gamma(00000180)=0.132901874385081E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 180 z1= 1 0.877526048512923E-04 0.000000000000000E+00 z1= 2 0.115488413962670E-06 0.000000000000000E+00 z1= 3 -.128465121708140E-06 0.000000000000000E+00 alpha(00000180)=0.000000000000000E+00 beta (00000181)=0.126737433521439E+02 gamma(00000181)=0.126737433521439E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 181 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000181)=0.000000000000000E+00 beta (00000182)=0.136833885607954E+02 gamma(00000182)=0.136833885607954E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 182 z1= 1 -.212036612078706E-03 0.000000000000000E+00 z1= 2 -.111248587102196E-06 0.000000000000000E+00 z1= 3 0.124922697315093E-06 0.000000000000000E+00 alpha(00000182)=0.000000000000000E+00 beta (00000183)=0.127712576911388E+02 gamma(00000183)=0.127712576911388E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 183 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000183)=0.000000000000000E+00 beta (00000184)=0.134436081472934E+02 gamma(00000184)=0.134436081472934E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 184 z1= 1 0.336400014603583E-03 0.000000000000000E+00 z1= 2 0.109675880003313E-06 0.000000000000000E+00 z1= 3 -.123254530822429E-06 0.000000000000000E+00 alpha(00000184)=0.000000000000000E+00 beta (00000185)=0.131257301113154E+02 gamma(00000185)=0.131257301113154E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 185 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000185)=0.000000000000000E+00 beta (00000186)=0.142025085566558E+02 gamma(00000186)=0.142025085566558E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 186 z1= 1 -.393624790861994E-03 0.000000000000000E+00 z1= 2 -.104710421014020E-06 0.000000000000000E+00 z1= 3 0.118322095890230E-06 0.000000000000000E+00 alpha(00000186)=0.000000000000000E+00 beta (00000187)=0.127865146418160E+02 gamma(00000187)=0.127865146418160E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 187 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000187)=0.000000000000000E+00 beta (00000188)=0.131985017674004E+02 gamma(00000188)=0.131985017674004E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 188 z1= 1 0.410946375967744E-03 0.000000000000000E+00 z1= 2 0.104502444548977E-06 0.000000000000000E+00 z1= 3 -.119236278423723E-06 0.000000000000000E+00 alpha(00000188)=0.000000000000000E+00 beta (00000189)=0.129108643525357E+02 gamma(00000189)=0.129108643525357E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 189 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000189)=0.000000000000000E+00 beta (00000190)=0.141431624214849E+02 gamma(00000190)=0.141431624214849E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 190 z1= 1 -.384967149944423E-03 0.000000000000000E+00 z1= 2 -.975591957210961E-07 0.000000000000000E+00 z1= 3 0.112008065260077E-06 0.000000000000000E+00 alpha(00000190)=0.000000000000000E+00 beta (00000191)=0.126098017494230E+02 gamma(00000191)=0.126098017494230E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 191 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000191)=0.000000000000000E+00 beta (00000192)=0.136884498488105E+02 gamma(00000192)=0.136884498488105E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 192 z1= 1 0.333069433715862E-03 0.000000000000000E+00 z1= 2 0.923040390076596E-07 0.000000000000000E+00 z1= 3 -.106511181352823E-06 0.000000000000000E+00 alpha(00000192)=0.000000000000000E+00 beta (00000193)=0.125495077391731E+02 gamma(00000193)=0.125495077391731E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 193 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000193)=0.000000000000000E+00 beta (00000194)=0.129665725911702E+02 gamma(00000194)=0.129665725911702E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 194 z1= 1 -.307347102190231E-03 0.000000000000000E+00 z1= 2 -.921004885377774E-07 0.000000000000000E+00 z1= 3 0.105870766869878E-06 0.000000000000000E+00 alpha(00000194)=0.000000000000000E+00 beta (00000195)=0.131997611401821E+02 gamma(00000195)=0.131997611401821E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 195 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000195)=0.000000000000000E+00 beta (00000196)=0.138207086861912E+02 gamma(00000196)=0.138207086861912E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 196 z1= 1 0.227687303037337E-03 0.000000000000000E+00 z1= 2 0.899041370768308E-07 0.000000000000000E+00 z1= 3 -.103520257766984E-06 0.000000000000000E+00 alpha(00000196)=0.000000000000000E+00 beta (00000197)=0.133772249705409E+02 gamma(00000197)=0.133772249705409E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 197 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000197)=0.000000000000000E+00 beta (00000198)=0.140061119425202E+02 gamma(00000198)=0.140061119425202E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 198 z1= 1 -.650404920353696E-04 0.000000000000000E+00 z1= 2 -.872773062658011E-07 0.000000000000000E+00 z1= 3 0.101738483905284E-06 0.000000000000000E+00 alpha(00000198)=0.000000000000000E+00 beta (00000199)=0.126385158343864E+02 gamma(00000199)=0.126385158343864E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 199 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000199)=0.000000000000000E+00 beta (00000200)=0.135378040367884E+02 gamma(00000200)=0.135378040367884E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 200 z1= 1 -.154713039355076E-03 0.000000000000000E+00 z1= 2 0.827643748457438E-07 0.000000000000000E+00 z1= 3 -.991642746768018E-07 0.000000000000000E+00 alpha(00000200)=0.000000000000000E+00 beta (00000201)=0.121675483742494E+02 gamma(00000201)=0.121675483742494E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 201 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000201)=0.000000000000000E+00 beta (00000202)=0.137941568302359E+02 gamma(00000202)=0.137941568302359E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 202 z1= 1 0.365471759134704E-03 0.000000000000000E+00 z1= 2 -.747084824277537E-07 0.000000000000000E+00 z1= 3 0.919850855669608E-07 0.000000000000000E+00 alpha(00000202)=0.000000000000000E+00 beta (00000203)=0.128273466421504E+02 gamma(00000203)=0.128273466421504E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 203 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000203)=0.000000000000000E+00 beta (00000204)=0.136965995347762E+02 gamma(00000204)=0.136965995347762E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 204 z1= 1 -.554076685313076E-03 0.000000000000000E+00 z1= 2 0.723765010224656E-07 0.000000000000000E+00 z1= 3 -.904035566661734E-07 0.000000000000000E+00 alpha(00000204)=0.000000000000000E+00 beta (00000205)=0.121520306435785E+02 gamma(00000205)=0.121520306435785E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 205 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000205)=0.000000000000000E+00 beta (00000206)=0.135215306931037E+02 gamma(00000206)=0.135215306931037E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 206 z1= 1 0.608978676509664E-03 0.000000000000000E+00 z1= 2 -.683656247533332E-07 0.000000000000000E+00 z1= 3 0.858616349434988E-07 0.000000000000000E+00 alpha(00000206)=0.000000000000000E+00 beta (00000207)=0.124827244110193E+02 gamma(00000207)=0.124827244110193E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 207 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000207)=0.000000000000000E+00 beta (00000208)=0.134709369994686E+02 gamma(00000208)=0.134709369994686E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 208 z1= 1 -.633329605222544E-03 0.000000000000000E+00 z1= 2 0.671644593179879E-07 0.000000000000000E+00 z1= 3 -.862659489236759E-07 0.000000000000000E+00 alpha(00000208)=0.000000000000000E+00 beta (00000209)=0.123383344520718E+02 gamma(00000209)=0.123383344520718E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 209 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000209)=0.000000000000000E+00 beta (00000210)=0.133462114435030E+02 gamma(00000210)=0.133462114435030E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 210 z1= 1 0.710331219234809E-03 0.000000000000000E+00 z1= 2 -.659838243332461E-07 0.000000000000000E+00 z1= 3 0.878501219052862E-07 0.000000000000000E+00 alpha(00000210)=0.000000000000000E+00 beta (00000211)=0.131432100675539E+02 gamma(00000211)=0.131432100675539E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 211 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000211)=0.000000000000000E+00 beta (00000212)=0.129313050926530E+02 gamma(00000212)=0.129313050926530E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 212 z1= 1 -.787524525886254E-03 0.000000000000000E+00 z1= 2 0.722950518634163E-07 0.000000000000000E+00 z1= 3 -.963385257946297E-07 0.000000000000000E+00 alpha(00000212)=0.000000000000000E+00 beta (00000213)=0.120316619868578E+02 gamma(00000213)=0.120316619868578E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 213 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000213)=0.000000000000000E+00 beta (00000214)=0.134635654474346E+02 gamma(00000214)=0.134635654474346E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 214 z1= 1 0.575132826351372E-03 0.000000000000000E+00 z1= 2 -.704203666976322E-07 0.000000000000000E+00 z1= 3 0.927074663202663E-07 0.000000000000000E+00 alpha(00000214)=0.000000000000000E+00 beta (00000215)=0.127773679467287E+02 gamma(00000215)=0.127773679467287E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 215 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000215)=0.000000000000000E+00 beta (00000216)=0.137654269978937E+02 gamma(00000216)=0.137654269978937E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 216 z1= 1 -.157535460016106E-03 0.000000000000000E+00 z1= 2 0.701679379140271E-07 0.000000000000000E+00 z1= 3 -.914367456772988E-07 0.000000000000000E+00 alpha(00000216)=0.000000000000000E+00 beta (00000217)=0.129434877758679E+02 gamma(00000217)=0.129434877758679E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 217 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000217)=0.000000000000000E+00 beta (00000218)=0.135801772833583E+02 gamma(00000218)=0.135801772833583E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 218 z1= 1 -.397926413315795E-03 0.000000000000000E+00 z1= 2 -.732228432687512E-07 0.000000000000000E+00 z1= 3 0.920473019706478E-07 0.000000000000000E+00 alpha(00000218)=0.000000000000000E+00 beta (00000219)=0.131426397109869E+02 gamma(00000219)=0.131426397109869E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 219 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000219)=0.000000000000000E+00 beta (00000220)=0.139478829134531E+02 gamma(00000220)=0.139478829134531E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 220 z1= 1 0.976300341844582E-03 0.000000000000000E+00 z1= 2 0.749515743441419E-07 0.000000000000000E+00 z1= 3 -.911178758127582E-07 0.000000000000000E+00 alpha(00000220)=0.000000000000000E+00 beta (00000221)=0.131240207905803E+02 gamma(00000221)=0.131240207905803E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 221 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000221)=0.000000000000000E+00 beta (00000222)=0.139778834836454E+02 gamma(00000222)=0.139778834836454E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 222 z1= 1 -.144068863122263E-02 0.000000000000000E+00 z1= 2 -.764996945087568E-07 0.000000000000000E+00 z1= 3 0.893916580484329E-07 0.000000000000000E+00 alpha(00000222)=0.000000000000000E+00 beta (00000223)=0.124280499315904E+02 gamma(00000223)=0.124280499315904E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 223 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000223)=0.000000000000000E+00 beta (00000224)=0.132944042165387E+02 gamma(00000224)=0.132944042165387E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 224 z1= 1 0.185288191366343E-02 0.000000000000000E+00 z1= 2 0.786114231592083E-07 0.000000000000000E+00 z1= 3 -.882796987613610E-07 0.000000000000000E+00 alpha(00000224)=0.000000000000000E+00 beta (00000225)=0.122136740790971E+02 gamma(00000225)=0.122136740790971E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 225 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000225)=0.000000000000000E+00 beta (00000226)=0.138023404975983E+02 gamma(00000226)=0.138023404975983E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 226 z1= 1 -.205756688973609E-02 0.000000000000000E+00 z1= 2 -.741941071189141E-07 0.000000000000000E+00 z1= 3 0.826736878877736E-07 0.000000000000000E+00 alpha(00000226)=0.000000000000000E+00 beta (00000227)=0.128195349325989E+02 gamma(00000227)=0.128195349325989E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 227 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000227)=0.000000000000000E+00 beta (00000228)=0.133703306400962E+02 gamma(00000228)=0.133703306400962E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 228 z1= 1 0.232579233285364E-02 0.000000000000000E+00 z1= 2 0.765876728521173E-07 0.000000000000000E+00 z1= 3 -.838057278983065E-07 0.000000000000000E+00 alpha(00000228)=0.000000000000000E+00 beta (00000229)=0.125924977392223E+02 gamma(00000229)=0.125924977392223E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 229 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000229)=0.000000000000000E+00 beta (00000230)=0.130192238495412E+02 gamma(00000230)=0.130192238495412E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 230 z1= 1 -.254073825265872E-02 0.000000000000000E+00 z1= 2 -.798260673916251E-07 0.000000000000000E+00 z1= 3 0.852649889793915E-07 0.000000000000000E+00 alpha(00000230)=0.000000000000000E+00 beta (00000231)=0.127333225488857E+02 gamma(00000231)=0.127333225488857E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 231 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000231)=0.000000000000000E+00 beta (00000232)=0.139348368116473E+02 gamma(00000232)=0.139348368116473E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 232 z1= 1 0.246909135939731E-02 0.000000000000000E+00 z1= 2 0.780706070095324E-07 0.000000000000000E+00 z1= 3 -.806823618133877E-07 0.000000000000000E+00 alpha(00000232)=0.000000000000000E+00 beta (00000233)=0.130952337864249E+02 gamma(00000233)=0.130952337864249E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 233 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000233)=0.000000000000000E+00 beta (00000234)=0.137082988934976E+02 gamma(00000234)=0.137082988934976E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 234 z1= 1 -.244724302993718E-02 0.000000000000000E+00 z1= 2 -.800468104092400E-07 0.000000000000000E+00 z1= 3 0.790500415411119E-07 0.000000000000000E+00 alpha(00000234)=0.000000000000000E+00 beta (00000235)=0.130599290955907E+02 gamma(00000235)=0.130599290955907E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 235 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000235)=0.000000000000000E+00 beta (00000236)=0.137365070151463E+02 gamma(00000236)=0.137365070151463E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 236 z1= 1 0.235351529114052E-02 0.000000000000000E+00 z1= 2 0.821823775386255E-07 0.000000000000000E+00 z1= 3 -.768190099145792E-07 0.000000000000000E+00 alpha(00000236)=0.000000000000000E+00 beta (00000237)=0.129746604454831E+02 gamma(00000237)=0.129746604454831E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 237 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000237)=0.000000000000000E+00 beta (00000238)=0.134991659659176E+02 gamma(00000238)=0.134991659659176E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 238 z1= 1 -.221080152377784E-02 0.000000000000000E+00 z1= 2 -.872002399537018E-07 0.000000000000000E+00 z1= 3 0.758675051586795E-07 0.000000000000000E+00 alpha(00000238)=0.000000000000000E+00 beta (00000239)=0.128953536671811E+02 gamma(00000239)=0.128953536671811E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 239 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000239)=0.000000000000000E+00 beta (00000240)=0.140822830738156E+02 gamma(00000240)=0.140822830738156E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 240 z1= 1 0.197406804102559E-02 0.000000000000000E+00 z1= 2 0.880486626411671E-07 0.000000000000000E+00 z1= 3 -.710268198059042E-07 0.000000000000000E+00 alpha(00000240)=0.000000000000000E+00 beta (00000241)=0.127853618138018E+02 gamma(00000241)=0.127853618138018E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 241 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000241)=0.000000000000000E+00 beta (00000242)=0.137913020201663E+02 gamma(00000242)=0.137913020201663E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 242 z1= 1 -.177466675862374E-02 0.000000000000000E+00 z1= 2 -.890438312144744E-07 0.000000000000000E+00 z1= 3 0.669703788236907E-07 0.000000000000000E+00 alpha(00000242)=0.000000000000000E+00 beta (00000243)=0.128796894324924E+02 gamma(00000243)=0.128796894324924E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 243 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000243)=0.000000000000000E+00 beta (00000244)=0.129163209694553E+02 gamma(00000244)=0.129163209694553E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 244 z1= 1 0.173033327986788E-02 0.000000000000000E+00 z1= 2 0.967242075403389E-07 0.000000000000000E+00 z1= 3 -.681217983114404E-07 0.000000000000000E+00 alpha(00000244)=0.000000000000000E+00 beta (00000245)=0.122324383167147E+02 gamma(00000245)=0.122324383167147E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 245 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000245)=0.000000000000000E+00 beta (00000246)=0.134038456890423E+02 gamma(00000246)=0.134038456890423E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 246 z1= 1 -.154101555063616E-02 0.000000000000000E+00 z1= 2 -.940604495758626E-07 0.000000000000000E+00 z1= 3 0.630630688394467E-07 0.000000000000000E+00 alpha(00000246)=0.000000000000000E+00 beta (00000247)=0.122777853411243E+02 gamma(00000247)=0.122777853411243E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 247 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000247)=0.000000000000000E+00 beta (00000248)=0.135848197738954E+02 gamma(00000248)=0.135848197738954E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 248 z1= 1 0.142001410329031E-02 0.000000000000000E+00 z1= 2 0.895883927453257E-07 0.000000000000000E+00 z1= 3 -.575135386570499E-07 0.000000000000000E+00 alpha(00000248)=0.000000000000000E+00 beta (00000249)=0.130687296425519E+02 gamma(00000249)=0.130687296425519E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 249 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000249)=0.000000000000000E+00 beta (00000250)=0.134102287034365E+02 gamma(00000250)=0.134102287034365E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 250 z1= 1 -.143105835711478E-02 0.000000000000000E+00 z1= 2 -.924278818468550E-07 0.000000000000000E+00 z1= 3 0.571190765412464E-07 0.000000000000000E+00 alpha(00000250)=0.000000000000000E+00 beta (00000251)=0.126421971033621E+02 gamma(00000251)=0.126421971033621E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 251 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000251)=0.000000000000000E+00 beta (00000252)=0.137096207381129E+02 gamma(00000252)=0.137096207381129E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 252 z1= 1 0.145225560032723E-02 0.000000000000000E+00 z1= 2 0.870510761395889E-07 0.000000000000000E+00 z1= 3 -.533414261800742E-07 0.000000000000000E+00 alpha(00000252)=0.000000000000000E+00 beta (00000253)=0.128989859912348E+02 gamma(00000253)=0.128989859912348E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 253 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000253)=0.000000000000000E+00 beta (00000254)=0.133010395033804E+02 gamma(00000254)=0.133010395033804E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 254 z1= 1 -.156838425001268E-02 0.000000000000000E+00 z1= 2 -.845812446416318E-07 0.000000000000000E+00 z1= 3 0.529566403735581E-07 0.000000000000000E+00 alpha(00000254)=0.000000000000000E+00 beta (00000255)=0.122325696988127E+02 gamma(00000255)=0.122325696988127E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 255 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000255)=0.000000000000000E+00 beta (00000256)=0.143760072057389E+02 gamma(00000256)=0.143760072057389E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 256 z1= 1 0.149820002445540E-02 0.000000000000000E+00 z1= 2 0.731755512016789E-07 0.000000000000000E+00 z1= 3 -.467780208662848E-07 0.000000000000000E+00 alpha(00000256)=0.000000000000000E+00 beta (00000257)=0.124168913270885E+02 gamma(00000257)=0.124168913270885E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 257 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000257)=0.000000000000000E+00 beta (00000258)=0.133196410384974E+02 gamma(00000258)=0.133196410384974E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 258 z1= 1 -.168685586492489E-02 0.000000000000000E+00 z1= 2 -.676144581552261E-07 0.000000000000000E+00 z1= 3 0.450387853608860E-07 0.000000000000000E+00 alpha(00000258)=0.000000000000000E+00 beta (00000259)=0.127162312076188E+02 gamma(00000259)=0.127162312076188E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 259 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000259)=0.000000000000000E+00 beta (00000260)=0.136365144230740E+02 gamma(00000260)=0.136365144230740E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 260 z1= 1 0.192725664507373E-02 0.000000000000000E+00 z1= 2 0.614426480419032E-07 0.000000000000000E+00 z1= 3 -.446929961560533E-07 0.000000000000000E+00 alpha(00000260)=0.000000000000000E+00 beta (00000261)=0.125281261185798E+02 gamma(00000261)=0.125281261185798E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 261 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000261)=0.000000000000000E+00 beta (00000262)=0.137293769671098E+02 gamma(00000262)=0.137293769671098E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 262 z1= 1 -.213383382803895E-02 0.000000000000000E+00 z1= 2 -.545656069386551E-07 0.000000000000000E+00 z1= 3 0.434463851985525E-07 0.000000000000000E+00 alpha(00000262)=0.000000000000000E+00 beta (00000263)=0.128310530120767E+02 gamma(00000263)=0.128310530120767E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 263 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000263)=0.000000000000000E+00 beta (00000264)=0.133327095122622E+02 gamma(00000264)=0.133327095122622E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 264 z1= 1 0.233276735083499E-02 0.000000000000000E+00 z1= 2 0.524019030923549E-07 0.000000000000000E+00 z1= 3 -.433123002935082E-07 0.000000000000000E+00 alpha(00000264)=0.000000000000000E+00 beta (00000265)=0.131090118327003E+02 gamma(00000265)=0.131090118327003E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 265 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000265)=0.000000000000000E+00 beta (00000266)=0.135958546719622E+02 gamma(00000266)=0.135958546719622E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 266 z1= 1 -.240896591567218E-02 0.000000000000000E+00 z1= 2 -.502671706550939E-07 0.000000000000000E+00 z1= 3 0.437180123773911E-07 0.000000000000000E+00 alpha(00000266)=0.000000000000000E+00 beta (00000267)=0.129880409514805E+02 gamma(00000267)=0.129880409514805E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 267 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000267)=0.000000000000000E+00 beta (00000268)=0.133629499764036E+02 gamma(00000268)=0.133629499764036E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 268 z1= 1 0.257428425499380E-02 0.000000000000000E+00 z1= 2 0.479969157959892E-07 0.000000000000000E+00 z1= 3 -.443619817705010E-07 0.000000000000000E+00 alpha(00000268)=0.000000000000000E+00 beta (00000269)=0.121759133430533E+02 gamma(00000269)=0.121759133430533E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 269 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000269)=0.000000000000000E+00 beta (00000270)=0.135466228345978E+02 gamma(00000270)=0.135466228345978E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 270 z1= 1 -.255266333691653E-02 0.000000000000000E+00 z1= 2 -.430135474269872E-07 0.000000000000000E+00 z1= 3 0.425067020503917E-07 0.000000000000000E+00 alpha(00000270)=0.000000000000000E+00 beta (00000271)=0.125732352421967E+02 gamma(00000271)=0.125732352421967E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 271 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000271)=0.000000000000000E+00 beta (00000272)=0.138866567827211E+02 gamma(00000272)=0.138866567827211E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 272 z1= 1 0.249898904383531E-02 0.000000000000000E+00 z1= 2 0.404795542233508E-07 0.000000000000000E+00 z1= 3 -.407123881582087E-07 0.000000000000000E+00 alpha(00000272)=0.000000000000000E+00 beta (00000273)=0.127527354780594E+02 gamma(00000273)=0.127527354780594E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 273 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000273)=0.000000000000000E+00 beta (00000274)=0.137255342811087E+02 gamma(00000274)=0.137255342811087E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 274 z1= 1 -.243688095480100E-02 0.000000000000000E+00 z1= 2 -.401821821944398E-07 0.000000000000000E+00 z1= 3 0.390622403910273E-07 0.000000000000000E+00 alpha(00000274)=0.000000000000000E+00 beta (00000275)=0.130992335465052E+02 gamma(00000275)=0.130992335465052E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 275 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000275)=0.000000000000000E+00 beta (00000276)=0.133642777620219E+02 gamma(00000276)=0.133642777620219E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 276 z1= 1 0.253198044535556E-02 0.000000000000000E+00 z1= 2 0.423407455381331E-07 0.000000000000000E+00 z1= 3 -.402691924202871E-07 0.000000000000000E+00 alpha(00000276)=0.000000000000000E+00 beta (00000277)=0.121173631809918E+02 gamma(00000277)=0.121173631809918E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 277 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000277)=0.000000000000000E+00 beta (00000278)=0.139902187691827E+02 gamma(00000278)=0.139902187691827E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 278 z1= 1 -.234375357402537E-02 0.000000000000000E+00 z1= 2 -.401850404662188E-07 0.000000000000000E+00 z1= 3 0.380689703721130E-07 0.000000000000000E+00 alpha(00000278)=0.000000000000000E+00 beta (00000279)=0.128103216790537E+02 gamma(00000279)=0.128103216790537E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 279 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000279)=0.000000000000000E+00 beta (00000280)=0.132105614508420E+02 gamma(00000280)=0.132105614508420E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 280 z1= 1 0.242952732538289E-02 0.000000000000000E+00 z1= 2 0.433585504054299E-07 0.000000000000000E+00 z1= 3 -.398212101260145E-07 0.000000000000000E+00 alpha(00000280)=0.000000000000000E+00 beta (00000281)=0.125789427138854E+02 gamma(00000281)=0.125789427138854E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 281 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000281)=0.000000000000000E+00 beta (00000282)=0.131349947309563E+02 gamma(00000282)=0.131349947309563E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 282 z1= 1 -.246825858304297E-02 0.000000000000000E+00 z1= 2 -.450218640779890E-07 0.000000000000000E+00 z1= 3 0.406219826141823E-07 0.000000000000000E+00 alpha(00000282)=0.000000000000000E+00 beta (00000283)=0.131792540416523E+02 gamma(00000283)=0.131792540416523E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 283 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000283)=0.000000000000000E+00 beta (00000284)=0.143606193216899E+02 gamma(00000284)=0.143606193216899E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 284 z1= 1 0.240362923476792E-02 0.000000000000000E+00 z1= 2 0.458650870837317E-07 0.000000000000000E+00 z1= 3 -.381776778711634E-07 0.000000000000000E+00 alpha(00000284)=0.000000000000000E+00 beta (00000285)=0.126008227210512E+02 gamma(00000285)=0.126008227210512E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 285 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000285)=0.000000000000000E+00 beta (00000286)=0.132861191403054E+02 gamma(00000286)=0.132861191403054E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 286 z1= 1 -.242917111808890E-02 0.000000000000000E+00 z1= 2 -.486362623445657E-07 0.000000000000000E+00 z1= 3 0.363964938128502E-07 0.000000000000000E+00 alpha(00000286)=0.000000000000000E+00 beta (00000287)=0.120640896779395E+02 gamma(00000287)=0.120640896779395E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 287 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000287)=0.000000000000000E+00 beta (00000288)=0.138125756495603E+02 gamma(00000288)=0.138125756495603E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 288 z1= 1 0.233248939659479E-02 0.000000000000000E+00 z1= 2 0.474232603590342E-07 0.000000000000000E+00 z1= 3 -.325118178295079E-07 0.000000000000000E+00 alpha(00000288)=0.000000000000000E+00 beta (00000289)=0.129650688133573E+02 gamma(00000289)=0.129650688133573E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 289 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000289)=0.000000000000000E+00 beta (00000290)=0.130428707505361E+02 gamma(00000290)=0.130428707505361E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 290 z1= 1 -.246437387656159E-02 0.000000000000000E+00 z1= 2 -.533474493950685E-07 0.000000000000000E+00 z1= 3 0.331817784165155E-07 0.000000000000000E+00 alpha(00000290)=0.000000000000000E+00 beta (00000291)=0.125821646290072E+02 gamma(00000291)=0.125821646290072E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 291 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000291)=0.000000000000000E+00 beta (00000292)=0.143053646788345E+02 gamma(00000292)=0.143053646788345E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 292 z1= 1 0.226394005340713E-02 0.000000000000000E+00 z1= 2 0.526420408956604E-07 0.000000000000000E+00 z1= 3 -.293623552177942E-07 0.000000000000000E+00 alpha(00000292)=0.000000000000000E+00 beta (00000293)=0.125510489125791E+02 gamma(00000293)=0.125510489125791E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 293 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000293)=0.000000000000000E+00 beta (00000294)=0.129608625253554E+02 gamma(00000294)=0.129608625253554E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 294 z1= 1 -.220780431613170E-02 0.000000000000000E+00 z1= 2 -.564670320515014E-07 0.000000000000000E+00 z1= 3 0.288619242936640E-07 0.000000000000000E+00 alpha(00000294)=0.000000000000000E+00 beta (00000295)=0.125944819137519E+02 gamma(00000295)=0.125944819137519E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 295 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000295)=0.000000000000000E+00 beta (00000296)=0.131303101707836E+02 gamma(00000296)=0.131303101707836E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 296 z1= 1 0.214127172525963E-02 0.000000000000000E+00 z1= 2 0.570464848011730E-07 0.000000000000000E+00 z1= 3 -.285652502760633E-07 0.000000000000000E+00 alpha(00000296)=0.000000000000000E+00 beta (00000297)=0.129644163241413E+02 gamma(00000297)=0.129644163241413E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 297 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000297)=0.000000000000000E+00 beta (00000298)=0.139129397679724E+02 gamma(00000298)=0.139129397679724E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 298 z1= 1 -.209146970861520E-02 0.000000000000000E+00 z1= 2 -.548889674848937E-07 0.000000000000000E+00 z1= 3 0.273396448130254E-07 0.000000000000000E+00 alpha(00000298)=0.000000000000000E+00 beta (00000299)=0.122088050820976E+02 gamma(00000299)=0.122088050820976E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 299 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000299)=0.000000000000000E+00 beta (00000300)=0.141344260082735E+02 gamma(00000300)=0.141344260082735E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 300 z1= 1 0.201349714838462E-02 0.000000000000000E+00 z1= 2 0.483444631419264E-07 0.000000000000000E+00 z1= 3 -.237501851093821E-07 0.000000000000000E+00 alpha(00000300)=0.000000000000000E+00 beta (00000301)=0.124100233642657E+02 gamma(00000301)=0.124100233642657E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 301 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000301)=0.000000000000000E+00 beta (00000302)=0.132831953192916E+02 gamma(00000302)=0.132831953192916E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 302 z1= 1 -.206786726436703E-02 0.000000000000000E+00 z1= 2 -.464510165833123E-07 0.000000000000000E+00 z1= 3 0.213659187469142E-07 0.000000000000000E+00 alpha(00000302)=0.000000000000000E+00 beta (00000303)=0.123637063285550E+02 gamma(00000303)=0.123637063285550E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 303 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000303)=0.000000000000000E+00 beta (00000304)=0.140368832892280E+02 gamma(00000304)=0.140368832892280E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 304 z1= 1 0.189058105446043E-02 0.000000000000000E+00 z1= 2 0.442511319596710E-07 0.000000000000000E+00 z1= 3 -.178190709918544E-07 0.000000000000000E+00 alpha(00000304)=0.000000000000000E+00 beta (00000305)=0.128030399619002E+02 gamma(00000305)=0.128030399619002E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 305 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000305)=0.000000000000000E+00 beta (00000306)=0.138048899126818E+02 gamma(00000306)=0.138048899126818E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 306 z1= 1 -.183299230520450E-02 0.000000000000000E+00 z1= 2 -.429666748905360E-07 0.000000000000000E+00 z1= 3 0.154524543630576E-07 0.000000000000000E+00 alpha(00000306)=0.000000000000000E+00 beta (00000307)=0.131498929869141E+02 gamma(00000307)=0.131498929869141E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 307 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000307)=0.000000000000000E+00 beta (00000308)=0.136632651854141E+02 gamma(00000308)=0.136632651854141E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 308 z1= 1 0.183638428891827E-02 0.000000000000000E+00 z1= 2 0.404503991942654E-07 0.000000000000000E+00 z1= 3 -.145019341708796E-07 0.000000000000000E+00 alpha(00000308)=0.000000000000000E+00 beta (00000309)=0.133362203946742E+02 gamma(00000309)=0.133362203946742E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 309 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000309)=0.000000000000000E+00 beta (00000310)=0.134460783849493E+02 gamma(00000310)=0.134460783849493E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 310 z1= 1 -.184686446755162E-02 0.000000000000000E+00 z1= 2 -.379815545808733E-07 0.000000000000000E+00 z1= 3 0.136500078960202E-07 0.000000000000000E+00 alpha(00000310)=0.000000000000000E+00 beta (00000311)=0.126213264838991E+02 gamma(00000311)=0.126213264838991E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 311 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000311)=0.000000000000000E+00 beta (00000312)=0.132179150321725E+02 gamma(00000312)=0.132179150321725E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 312 z1= 1 0.169540512664358E-02 0.000000000000000E+00 z1= 2 0.348057959220598E-07 0.000000000000000E+00 z1= 3 -.114482613357758E-07 0.000000000000000E+00 alpha(00000312)=0.000000000000000E+00 beta (00000313)=0.122027133129977E+02 gamma(00000313)=0.122027133129977E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 313 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000313)=0.000000000000000E+00 beta (00000314)=0.135106339907098E+02 gamma(00000314)=0.135106339907098E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 314 z1= 1 -.137755019068584E-02 0.000000000000000E+00 z1= 2 -.333793317545700E-07 0.000000000000000E+00 z1= 3 0.887315253618546E-08 0.000000000000000E+00 alpha(00000314)=0.000000000000000E+00 beta (00000315)=0.126597232105636E+02 gamma(00000315)=0.126597232105636E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 315 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000315)=0.000000000000000E+00 beta (00000316)=0.137307511304488E+02 gamma(00000316)=0.137307511304488E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 316 z1= 1 0.100917438630602E-02 0.000000000000000E+00 z1= 2 0.319676096798265E-07 0.000000000000000E+00 z1= 3 -.636528584116620E-08 0.000000000000000E+00 alpha(00000316)=0.000000000000000E+00 beta (00000317)=0.117764877975117E+02 gamma(00000317)=0.117764877975117E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 317 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000317)=0.000000000000000E+00 beta (00000318)=0.140417103654157E+02 gamma(00000318)=0.140417103654157E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 318 z1= 1 -.439649881999401E-03 0.000000000000000E+00 z1= 2 -.264306891238804E-07 0.000000000000000E+00 z1= 3 0.269293614946382E-08 0.000000000000000E+00 alpha(00000318)=0.000000000000000E+00 beta (00000319)=0.132665405400300E+02 gamma(00000319)=0.132665405400300E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 319 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000319)=0.000000000000000E+00 beta (00000320)=0.141498038897304E+02 gamma(00000320)=0.141498038897304E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 320 z1= 1 0.398061263961642E-04 0.000000000000000E+00 z1= 2 0.235152491043786E-07 0.000000000000000E+00 z1= 3 -.695169791360434E-09 0.000000000000000E+00 alpha(00000320)=0.000000000000000E+00 beta (00000321)=0.121459074078597E+02 gamma(00000321)=0.121459074078597E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 321 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000321)=0.000000000000000E+00 beta (00000322)=0.139626676468207E+02 gamma(00000322)=0.139626676468207E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 322 z1= 1 0.320119754037906E-03 0.000000000000000E+00 z1= 2 -.178334674065788E-07 0.000000000000000E+00 z1= 3 0.197603184330783E-09 0.000000000000000E+00 alpha(00000322)=0.000000000000000E+00 beta (00000323)=0.124724725759777E+02 gamma(00000323)=0.124724725759777E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 323 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000323)=0.000000000000000E+00 beta (00000324)=0.144371892338379E+02 gamma(00000324)=0.144371892338379E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 324 z1= 1 -.511108553436502E-03 0.000000000000000E+00 z1= 2 0.140752696387242E-07 0.000000000000000E+00 z1= 3 -.609931966193719E-09 0.000000000000000E+00 alpha(00000324)=0.000000000000000E+00 beta (00000325)=0.132215869807168E+02 gamma(00000325)=0.132215869807168E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 325 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000325)=0.000000000000000E+00 beta (00000326)=0.141362694058182E+02 gamma(00000326)=0.141362694058182E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 326 z1= 1 0.543326740269906E-03 0.000000000000000E+00 z1= 2 -.104206962653081E-07 0.000000000000000E+00 z1= 3 0.149960836901431E-08 0.000000000000000E+00 alpha(00000326)=0.000000000000000E+00 beta (00000327)=0.125093983767794E+02 gamma(00000327)=0.125093983767794E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 327 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000327)=0.000000000000000E+00 beta (00000328)=0.131966810197416E+02 gamma(00000328)=0.131966810197416E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 328 z1= 1 -.433873288451421E-03 0.000000000000000E+00 z1= 2 0.514362789817355E-08 0.000000000000000E+00 z1= 3 -.225383790615681E-08 0.000000000000000E+00 alpha(00000328)=0.000000000000000E+00 beta (00000329)=0.130593888282178E+02 gamma(00000329)=0.130593888282178E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 329 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000329)=0.000000000000000E+00 beta (00000330)=0.139648679642118E+02 gamma(00000330)=0.139648679642118E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 330 z1= 1 0.288374013497046E-03 0.000000000000000E+00 z1= 2 0.118649221524103E-09 0.000000000000000E+00 z1= 3 0.192677149783065E-08 0.000000000000000E+00 alpha(00000330)=0.000000000000000E+00 beta (00000331)=0.121120542344021E+02 gamma(00000331)=0.121120542344021E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 331 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000331)=0.000000000000000E+00 beta (00000332)=0.138085259736552E+02 gamma(00000332)=0.138085259736552E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 332 z1= 1 -.159561124382012E-03 0.000000000000000E+00 z1= 2 -.238579068220085E-08 0.000000000000000E+00 z1= 3 -.905387873966499E-09 0.000000000000000E+00 alpha(00000332)=0.000000000000000E+00 beta (00000333)=0.124229959477280E+02 gamma(00000333)=0.124229959477280E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 333 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000333)=0.000000000000000E+00 beta (00000334)=0.130567728947594E+02 gamma(00000334)=0.130567728947594E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 334 z1= 1 0.835444761253332E-04 0.000000000000000E+00 z1= 2 0.292793527357366E-08 0.000000000000000E+00 z1= 3 -.591130212487800E-09 0.000000000000000E+00 alpha(00000334)=0.000000000000000E+00 beta (00000335)=0.128764307016046E+02 gamma(00000335)=0.128764307016046E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 335 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000335)=0.000000000000000E+00 beta (00000336)=0.129308756923354E+02 gamma(00000336)=0.129308756923354E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 336 z1= 1 -.120367969342345E-03 0.000000000000000E+00 z1= 2 -.468013607035633E-08 0.000000000000000E+00 z1= 3 0.245819913528139E-08 0.000000000000000E+00 alpha(00000336)=0.000000000000000E+00 beta (00000337)=0.127426744281894E+02 gamma(00000337)=0.127426744281894E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 337 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000337)=0.000000000000000E+00 beta (00000338)=0.125326938753669E+02 gamma(00000338)=0.125326938753669E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 338 z1= 1 0.249246023082406E-03 0.000000000000000E+00 z1= 2 0.781838682857583E-08 0.000000000000000E+00 z1= 3 -.303996307678611E-08 0.000000000000000E+00 alpha(00000338)=0.000000000000000E+00 beta (00000339)=0.139090549142364E+02 gamma(00000339)=0.139090549142364E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 339 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000339)=0.000000000000000E+00 beta (00000340)=0.135473100729274E+02 gamma(00000340)=0.135473100729274E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 340 z1= 1 -.386164204680291E-03 0.000000000000000E+00 z1= 2 -.107560998593124E-07 0.000000000000000E+00 z1= 3 0.485549685154348E-08 0.000000000000000E+00 alpha(00000340)=0.000000000000000E+00 beta (00000341)=0.122809387607634E+02 gamma(00000341)=0.122809387607634E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 341 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000341)=0.000000000000000E+00 beta (00000342)=0.139597480394209E+02 gamma(00000342)=0.139597480394209E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 342 z1= 1 0.549214977102471E-03 0.000000000000000E+00 z1= 2 0.118950371358340E-07 0.000000000000000E+00 z1= 3 -.616646784735615E-08 0.000000000000000E+00 alpha(00000342)=0.000000000000000E+00 beta (00000343)=0.127233515641193E+02 gamma(00000343)=0.127233515641193E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 343 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000343)=0.000000000000000E+00 beta (00000344)=0.137562643768342E+02 gamma(00000344)=0.137562643768342E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 344 z1= 1 -.782077269959158E-03 0.000000000000000E+00 z1= 2 -.146657250432378E-07 0.000000000000000E+00 z1= 3 0.786461900024145E-08 0.000000000000000E+00 alpha(00000344)=0.000000000000000E+00 beta (00000345)=0.123639887822700E+02 gamma(00000345)=0.123639887822700E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 345 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000345)=0.000000000000000E+00 beta (00000346)=0.142140964744682E+02 gamma(00000346)=0.142140964744682E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 346 z1= 1 0.909076763700590E-03 0.000000000000000E+00 z1= 2 0.145561904864658E-07 0.000000000000000E+00 z1= 3 -.776894270231265E-08 0.000000000000000E+00 alpha(00000346)=0.000000000000000E+00 beta (00000347)=0.124947272402144E+02 gamma(00000347)=0.124947272402144E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 347 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000347)=0.000000000000000E+00 beta (00000348)=0.146112869962901E+02 gamma(00000348)=0.146112869962901E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 348 z1= 1 -.107333081211053E-02 0.000000000000000E+00 z1= 2 -.155709071344122E-07 0.000000000000000E+00 z1= 3 0.843856770511896E-08 0.000000000000000E+00 alpha(00000348)=0.000000000000000E+00 beta (00000349)=0.121760530499338E+02 gamma(00000349)=0.121760530499338E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 349 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000349)=0.000000000000000E+00 beta (00000350)=0.129203928935061E+02 gamma(00000350)=0.129203928935061E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 350 z1= 1 0.137533671489889E-02 0.000000000000000E+00 z1= 2 0.207101993861605E-07 0.000000000000000E+00 z1= 3 -.107451175332884E-07 0.000000000000000E+00 alpha(00000350)=0.000000000000000E+00 beta (00000351)=0.128670454789221E+02 gamma(00000351)=0.128670454789221E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 351 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000351)=0.000000000000000E+00 beta (00000352)=0.140454442056506E+02 gamma(00000352)=0.140454442056506E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 352 z1= 1 -.146322330382047E-02 0.000000000000000E+00 z1= 2 -.249998270930238E-07 0.000000000000000E+00 z1= 3 0.127719855033540E-07 0.000000000000000E+00 alpha(00000352)=0.000000000000000E+00 beta (00000353)=0.125003560893117E+02 gamma(00000353)=0.125003560893117E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 353 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000353)=0.000000000000000E+00 beta (00000354)=0.134581950749329E+02 gamma(00000354)=0.134581950749329E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 354 z1= 1 0.147929724876703E-02 0.000000000000000E+00 z1= 2 0.308398593706731E-07 0.000000000000000E+00 z1= 3 -.148969169107543E-07 0.000000000000000E+00 alpha(00000354)=0.000000000000000E+00 beta (00000355)=0.125144410816080E+02 gamma(00000355)=0.125144410816080E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 355 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000355)=0.000000000000000E+00 beta (00000356)=0.133937393777500E+02 gamma(00000356)=0.133937393777500E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 356 z1= 1 -.146106621701059E-02 0.000000000000000E+00 z1= 2 -.392052787508840E-07 0.000000000000000E+00 z1= 3 0.164719259068355E-07 0.000000000000000E+00 alpha(00000356)=0.000000000000000E+00 beta (00000357)=0.123723884589435E+02 gamma(00000357)=0.123723884589435E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 357 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000357)=0.000000000000000E+00 beta (00000358)=0.137873371676265E+02 gamma(00000358)=0.137873371676265E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 358 z1= 1 0.124279400565338E-02 0.000000000000000E+00 z1= 2 0.457698546263950E-07 0.000000000000000E+00 z1= 3 -.151736976187534E-07 0.000000000000000E+00 alpha(00000358)=0.000000000000000E+00 beta (00000359)=0.125468405598852E+02 gamma(00000359)=0.125468405598852E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 359 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000359)=0.000000000000000E+00 beta (00000360)=0.137237000395838E+02 gamma(00000360)=0.137237000395838E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 360 z1= 1 -.880774345804605E-03 0.000000000000000E+00 z1= 2 -.561501535397899E-07 0.000000000000000E+00 z1= 3 0.165397537106203E-07 0.000000000000000E+00 alpha(00000360)=0.000000000000000E+00 beta (00000361)=0.124991249512475E+02 gamma(00000361)=0.124991249512475E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 361 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000361)=0.000000000000000E+00 beta (00000362)=0.132497097713457E+02 gamma(00000362)=0.132497097713457E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 362 z1= 1 0.402912591794978E-03 0.000000000000000E+00 z1= 2 0.659743146112432E-07 0.000000000000000E+00 z1= 3 -.168628485766674E-07 0.000000000000000E+00 alpha(00000362)=0.000000000000000E+00 beta (00000363)=0.127069504145385E+02 gamma(00000363)=0.127069504145385E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 363 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000363)=0.000000000000000E+00 beta (00000364)=0.139580370176100E+02 gamma(00000364)=0.139580370176100E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 364 z1= 1 0.210747748022678E-03 0.000000000000000E+00 z1= 2 -.767728329984473E-07 0.000000000000000E+00 z1= 3 0.186292528925889E-07 0.000000000000000E+00 alpha(00000364)=0.000000000000000E+00 beta (00000365)=0.130240096254129E+02 gamma(00000365)=0.130240096254129E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 365 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000365)=0.000000000000000E+00 beta (00000366)=0.131039557587331E+02 gamma(00000366)=0.131039557587331E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 366 z1= 1 -.751908490878767E-03 0.000000000000000E+00 z1= 2 0.883166721039885E-07 0.000000000000000E+00 z1= 3 -.184880555266151E-07 0.000000000000000E+00 alpha(00000366)=0.000000000000000E+00 beta (00000367)=0.127858560910802E+02 gamma(00000367)=0.127858560910802E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 367 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000367)=0.000000000000000E+00 beta (00000368)=0.130555808287586E+02 gamma(00000368)=0.130555808287586E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 368 z1= 1 0.119981676486374E-02 0.000000000000000E+00 z1= 2 -.104863632019100E-06 0.000000000000000E+00 z1= 3 0.219107402173505E-07 0.000000000000000E+00 alpha(00000368)=0.000000000000000E+00 beta (00000369)=0.124420069115894E+02 gamma(00000369)=0.124420069115894E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 369 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000369)=0.000000000000000E+00 beta (00000370)=0.138366504894395E+02 gamma(00000370)=0.138366504894395E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 370 z1= 1 -.146545330545088E-02 0.000000000000000E+00 z1= 2 0.103366228445785E-06 0.000000000000000E+00 z1= 3 -.191760813610543E-07 0.000000000000000E+00 alpha(00000370)=0.000000000000000E+00 beta (00000371)=0.124648572864457E+02 gamma(00000371)=0.124648572864457E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 371 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000371)=0.000000000000000E+00 beta (00000372)=0.136425334239812E+02 gamma(00000372)=0.136425334239812E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 372 z1= 1 0.165013706023719E-02 0.000000000000000E+00 z1= 2 -.110450654003153E-06 0.000000000000000E+00 z1= 3 0.235526907492152E-07 0.000000000000000E+00 alpha(00000372)=0.000000000000000E+00 beta (00000373)=0.126381092399263E+02 gamma(00000373)=0.126381092399263E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 373 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000373)=0.000000000000000E+00 beta (00000374)=0.138230516566740E+02 gamma(00000374)=0.138230516566740E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 374 z1= 1 -.190552011126464E-02 0.000000000000000E+00 z1= 2 0.102858445215608E-06 0.000000000000000E+00 z1= 3 -.197173535911618E-07 0.000000000000000E+00 alpha(00000374)=0.000000000000000E+00 beta (00000375)=0.133432339689140E+02 gamma(00000375)=0.133432339689140E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 375 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000375)=0.000000000000000E+00 beta (00000376)=0.137211201830187E+02 gamma(00000376)=0.137211201830187E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 376 z1= 1 0.222385021776609E-02 0.000000000000000E+00 z1= 2 -.119593943642346E-06 0.000000000000000E+00 z1= 3 0.282695534837077E-07 0.000000000000000E+00 alpha(00000376)=0.000000000000000E+00 beta (00000377)=0.124945017912639E+02 gamma(00000377)=0.124945017912639E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 377 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000377)=0.000000000000000E+00 beta (00000378)=0.140820333948445E+02 gamma(00000378)=0.140820333948445E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 378 z1= 1 -.215286368687271E-02 0.000000000000000E+00 z1= 2 0.102872881944764E-06 0.000000000000000E+00 z1= 3 -.212172287786987E-07 0.000000000000000E+00 alpha(00000378)=0.000000000000000E+00 beta (00000379)=0.123123803080729E+02 gamma(00000379)=0.123123803080729E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 379 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000379)=0.000000000000000E+00 beta (00000380)=0.132024419572222E+02 gamma(00000380)=0.132024419572222E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 380 z1= 1 0.202189105213329E-02 0.000000000000000E+00 z1= 2 -.115914604763637E-06 0.000000000000000E+00 z1= 3 0.268002393348423E-07 0.000000000000000E+00 alpha(00000380)=0.000000000000000E+00 beta (00000381)=0.127259994192195E+02 gamma(00000381)=0.127259994192195E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 381 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000381)=0.000000000000000E+00 beta (00000382)=0.136090312426988E+02 gamma(00000382)=0.136090312426988E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 382 z1= 1 -.166971426902434E-02 0.000000000000000E+00 z1= 2 0.102709995007970E-06 0.000000000000000E+00 z1= 3 -.172871697510287E-07 0.000000000000000E+00 alpha(00000382)=0.000000000000000E+00 beta (00000383)=0.137022815990906E+02 gamma(00000383)=0.137022815990906E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 383 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000383)=0.000000000000000E+00 beta (00000384)=0.129614691070087E+02 gamma(00000384)=0.129614691070087E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 384 z1= 1 0.145796832189607E-02 0.000000000000000E+00 z1= 2 -.131816945954030E-06 0.000000000000000E+00 z1= 3 0.268607672369772E-07 0.000000000000000E+00 alpha(00000384)=0.000000000000000E+00 beta (00000385)=0.122945615466299E+02 gamma(00000385)=0.122945615466299E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 385 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000385)=0.000000000000000E+00 beta (00000386)=0.143323235137157E+02 gamma(00000386)=0.143323235137157E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 386 z1= 1 -.105980975833271E-02 0.000000000000000E+00 z1= 2 0.104062453525327E-06 0.000000000000000E+00 z1= 3 -.129121490744519E-07 0.000000000000000E+00 alpha(00000386)=0.000000000000000E+00 beta (00000387)=0.123122619502842E+02 gamma(00000387)=0.123122619502842E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 387 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000387)=0.000000000000000E+00 beta (00000388)=0.138320296551587E+02 gamma(00000388)=0.138320296551587E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 388 z1= 1 0.812287640481635E-03 0.000000000000000E+00 z1= 2 -.120044075104398E-06 0.000000000000000E+00 z1= 3 0.218904509419367E-07 0.000000000000000E+00 alpha(00000388)=0.000000000000000E+00 beta (00000389)=0.130683197670438E+02 gamma(00000389)=0.130683197670438E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 389 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000389)=0.000000000000000E+00 beta (00000390)=0.133631066202536E+02 gamma(00000390)=0.133631066202536E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 390 z1= 1 -.724576614161285E-03 0.000000000000000E+00 z1= 2 0.102391782162356E-06 0.000000000000000E+00 z1= 3 -.973262496344138E-08 0.000000000000000E+00 alpha(00000390)=0.000000000000000E+00 beta (00000391)=0.129337327134376E+02 gamma(00000391)=0.129337327134376E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 391 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000391)=0.000000000000000E+00 beta (00000392)=0.131472279303099E+02 gamma(00000392)=0.131472279303099E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 392 z1= 1 0.721599144286451E-03 0.000000000000000E+00 z1= 2 -.131160523934859E-06 0.000000000000000E+00 z1= 3 0.235389976077595E-07 0.000000000000000E+00 alpha(00000392)=0.000000000000000E+00 beta (00000393)=0.132340558387490E+02 gamma(00000393)=0.132340558387490E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 393 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000393)=0.000000000000000E+00 beta (00000394)=0.136224217943331E+02 gamma(00000394)=0.136224217943331E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 394 z1= 1 -.720322070012866E-03 0.000000000000000E+00 z1= 2 0.107903402650055E-06 0.000000000000000E+00 z1= 3 -.931162476855776E-08 0.000000000000000E+00 alpha(00000394)=0.000000000000000E+00 beta (00000395)=0.120654471061978E+02 gamma(00000395)=0.120654471061978E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 395 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000395)=0.000000000000000E+00 beta (00000396)=0.141132767340279E+02 gamma(00000396)=0.141132767340279E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 396 z1= 1 0.533005277104460E-03 0.000000000000000E+00 z1= 2 -.125172070786564E-06 0.000000000000000E+00 z1= 3 0.248465108828189E-07 0.000000000000000E+00 alpha(00000396)=0.000000000000000E+00 beta (00000397)=0.132667863807673E+02 gamma(00000397)=0.132667863807673E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 397 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000397)=0.000000000000000E+00 beta (00000398)=0.143355203546100E+02 gamma(00000398)=0.143355203546100E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 398 z1= 1 -.313432150967071E-03 0.000000000000000E+00 z1= 2 0.842815033597066E-07 0.000000000000000E+00 z1= 3 -.719032870093519E-08 0.000000000000000E+00 alpha(00000398)=0.000000000000000E+00 beta (00000399)=0.120540475421963E+02 gamma(00000399)=0.120540475421963E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 399 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000399)=0.000000000000000E+00 beta (00000400)=0.133881535620954E+02 gamma(00000400)=0.133881535620954E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 400 z1= 1 0.350149514820510E-04 0.000000000000000E+00 z1= 2 -.105198530416309E-06 0.000000000000000E+00 z1= 3 0.218121175325162E-07 0.000000000000000E+00 alpha(00000400)=0.000000000000000E+00 beta (00000401)=0.129874554394504E+02 gamma(00000401)=0.129874554394504E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 401 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000401)=0.000000000000000E+00 beta (00000402)=0.133496322131635E+02 gamma(00000402)=0.133496322131635E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 402 z1= 1 0.834652387494018E-04 0.000000000000000E+00 z1= 2 0.744972155110324E-07 0.000000000000000E+00 z1= 3 -.689392931890048E-08 0.000000000000000E+00 alpha(00000402)=0.000000000000000E+00 beta (00000403)=0.129702440070357E+02 gamma(00000403)=0.129702440070357E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 403 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000403)=0.000000000000000E+00 beta (00000404)=0.138744915978265E+02 gamma(00000404)=0.138744915978265E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 404 z1= 1 -.135172583612614E-03 0.000000000000000E+00 z1= 2 -.102851238065367E-06 0.000000000000000E+00 z1= 3 0.216040799791862E-07 0.000000000000000E+00 alpha(00000404)=0.000000000000000E+00 beta (00000405)=0.134339622805830E+02 gamma(00000405)=0.134339622805830E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 405 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000405)=0.000000000000000E+00 beta (00000406)=0.135241996974093E+02 gamma(00000406)=0.135241996974093E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 406 z1= 1 0.214145970821701E-03 0.000000000000000E+00 z1= 2 0.780185463490624E-07 0.000000000000000E+00 z1= 3 -.925886234305270E-08 0.000000000000000E+00 alpha(00000406)=0.000000000000000E+00 beta (00000407)=0.130945999291714E+02 gamma(00000407)=0.130945999291714E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 407 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000407)=0.000000000000000E+00 beta (00000408)=0.139765893292880E+02 gamma(00000408)=0.139765893292880E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 408 z1= 1 -.255432048574289E-03 0.000000000000000E+00 z1= 2 -.967300069318507E-07 0.000000000000000E+00 z1= 3 0.180450847740883E-07 0.000000000000000E+00 alpha(00000408)=0.000000000000000E+00 beta (00000409)=0.127915203250471E+02 gamma(00000409)=0.127915203250471E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 409 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000409)=0.000000000000000E+00 beta (00000410)=0.126711102047447E+02 gamma(00000410)=0.126711102047447E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 410 z1= 1 0.320047782887943E-03 0.000000000000000E+00 z1= 2 0.921535303806138E-07 0.000000000000000E+00 z1= 3 -.155496528462607E-07 0.000000000000000E+00 alpha(00000410)=0.000000000000000E+00 beta (00000411)=0.129111189796919E+02 gamma(00000411)=0.129111189796919E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 411 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000411)=0.000000000000000E+00 beta (00000412)=0.138796253106202E+02 gamma(00000412)=0.138796253106202E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 412 z1= 1 -.325040530145339E-03 0.000000000000000E+00 z1= 2 -.931535795493064E-07 0.000000000000000E+00 z1= 3 0.138512085975191E-07 0.000000000000000E+00 alpha(00000412)=0.000000000000000E+00 beta (00000413)=0.123416825707410E+02 gamma(00000413)=0.123416825707410E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 413 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000413)=0.000000000000000E+00 beta (00000414)=0.137380135096257E+02 gamma(00000414)=0.137380135096257E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 414 z1= 1 0.274946787403130E-03 0.000000000000000E+00 z1= 2 0.972661655644245E-07 0.000000000000000E+00 z1= 3 -.201691503140454E-07 0.000000000000000E+00 alpha(00000414)=0.000000000000000E+00 beta (00000415)=0.129451376692175E+02 gamma(00000415)=0.129451376692175E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 415 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000415)=0.000000000000000E+00 beta (00000416)=0.130131171823332E+02 gamma(00000416)=0.130131171823332E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 416 z1= 1 -.199734812231144E-03 0.000000000000000E+00 z1= 2 -.912224444697685E-07 0.000000000000000E+00 z1= 3 0.944977165029566E-08 0.000000000000000E+00 alpha(00000416)=0.000000000000000E+00 beta (00000417)=0.120120822449414E+02 gamma(00000417)=0.120120822449414E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 417 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000417)=0.000000000000000E+00 beta (00000418)=0.128812686774298E+02 gamma(00000418)=0.128812686774298E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 418 z1= 1 -.483816665705338E-04 0.000000000000000E+00 z1= 2 0.119762221105491E-06 0.000000000000000E+00 z1= 3 -.278267708826501E-07 0.000000000000000E+00 alpha(00000418)=0.000000000000000E+00 beta (00000419)=0.133477745509318E+02 gamma(00000419)=0.133477745509318E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 419 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000419)=0.000000000000000E+00 beta (00000420)=0.138695292384274E+02 gamma(00000420)=0.138695292384274E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 420 z1= 1 0.361225058082785E-03 0.000000000000000E+00 z1= 2 -.804741444235518E-07 0.000000000000000E+00 z1= 3 -.434259126585752E-08 0.000000000000000E+00 alpha(00000420)=0.000000000000000E+00 beta (00000421)=0.126306108862148E+02 gamma(00000421)=0.126306108862148E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 421 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000421)=0.000000000000000E+00 beta (00000422)=0.143427386950538E+02 gamma(00000422)=0.143427386950538E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 422 z1= 1 -.644640258246130E-03 0.000000000000000E+00 z1= 2 0.132282567618194E-06 0.000000000000000E+00 z1= 3 -.343656531444749E-07 0.000000000000000E+00 alpha(00000422)=0.000000000000000E+00 beta (00000423)=0.124989818080970E+02 gamma(00000423)=0.124989818080970E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 423 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000423)=0.000000000000000E+00 beta (00000424)=0.132659148539154E+02 gamma(00000424)=0.132659148539154E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 424 z1= 1 0.945203406382424E-03 0.000000000000000E+00 z1= 2 -.650860339044407E-07 0.000000000000000E+00 z1= 3 -.170891432767955E-07 0.000000000000000E+00 alpha(00000424)=0.000000000000000E+00 beta (00000425)=0.129491621154362E+02 gamma(00000425)=0.129491621154362E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 425 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000425)=0.000000000000000E+00 beta (00000426)=0.143707177707667E+02 gamma(00000426)=0.143707177707667E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 426 z1= 1 -.113413332567618E-02 0.000000000000000E+00 z1= 2 0.136839198523362E-06 0.000000000000000E+00 z1= 3 -.357848562292790E-07 0.000000000000000E+00 alpha(00000426)=0.000000000000000E+00 beta (00000427)=0.130364302302030E+02 gamma(00000427)=0.130364302302030E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 427 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000427)=0.000000000000000E+00 beta (00000428)=0.142823489526896E+02 gamma(00000428)=0.142823489526896E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 428 z1= 1 0.130656776232530E-02 0.000000000000000E+00 z1= 2 -.579791323300407E-07 0.000000000000000E+00 z1= 3 -.170467791470673E-07 0.000000000000000E+00 alpha(00000428)=0.000000000000000E+00 beta (00000429)=0.122435004743919E+02 gamma(00000429)=0.122435004743919E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 429 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000429)=0.000000000000000E+00 beta (00000430)=0.134497420414201E+02 gamma(00000430)=0.134497420414201E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 430 z1= 1 -.154525729844228E-02 0.000000000000000E+00 z1= 2 0.110259405315368E-06 0.000000000000000E+00 z1= 3 -.246061222238620E-07 0.000000000000000E+00 alpha(00000430)=0.000000000000000E+00 beta (00000431)=0.126494568821274E+02 gamma(00000431)=0.126494568821274E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 431 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000431)=0.000000000000000E+00 beta (00000432)=0.136391925244097E+02 gamma(00000432)=0.136391925244097E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 432 z1= 1 0.183686994303350E-02 0.000000000000000E+00 z1= 2 -.635209739252574E-07 0.000000000000000E+00 z1= 3 -.771336733211298E-08 0.000000000000000E+00 alpha(00000432)=0.000000000000000E+00 beta (00000433)=0.128232219918018E+02 gamma(00000433)=0.128232219918018E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 433 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000433)=0.000000000000000E+00 beta (00000434)=0.140093646000212E+02 gamma(00000434)=0.140093646000212E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 434 z1= 1 -.198581474053765E-02 0.000000000000000E+00 z1= 2 0.931356284039619E-07 0.000000000000000E+00 z1= 3 -.138856547609971E-07 0.000000000000000E+00 alpha(00000434)=0.000000000000000E+00 beta (00000435)=0.118423769553736E+02 gamma(00000435)=0.118423769553736E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 435 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000435)=0.000000000000000E+00 beta (00000436)=0.130540984517911E+02 gamma(00000436)=0.130540984517911E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 436 z1= 1 0.201124106564413E-02 0.000000000000000E+00 z1= 2 -.682583618984850E-07 0.000000000000000E+00 z1= 3 -.306160668518685E-08 0.000000000000000E+00 alpha(00000436)=0.000000000000000E+00 beta (00000437)=0.122794171040889E+02 gamma(00000437)=0.122794171040889E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 437 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000437)=0.000000000000000E+00 beta (00000438)=0.138299715271784E+02 gamma(00000438)=0.138299715271784E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 438 z1= 1 -.176314549990432E-02 0.000000000000000E+00 z1= 2 0.790255618413234E-07 0.000000000000000E+00 z1= 3 -.829988208814626E-08 0.000000000000000E+00 alpha(00000438)=0.000000000000000E+00 beta (00000439)=0.133079801402846E+02 gamma(00000439)=0.133079801402846E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 439 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000439)=0.000000000000000E+00 beta (00000440)=0.134548068798160E+02 gamma(00000440)=0.134548068798160E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 440 z1= 1 0.152475600414237E-02 0.000000000000000E+00 z1= 2 -.623507366371082E-07 0.000000000000000E+00 z1= 3 -.345190026627799E-08 0.000000000000000E+00 alpha(00000440)=0.000000000000000E+00 beta (00000441)=0.133201293264097E+02 gamma(00000441)=0.133201293264097E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 441 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000441)=0.000000000000000E+00 beta (00000442)=0.135148854725451E+02 gamma(00000442)=0.135148854725451E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 442 z1= 1 -.114322522205540E-02 0.000000000000000E+00 z1= 2 0.720133350280098E-07 0.000000000000000E+00 z1= 3 -.384248191739271E-08 0.000000000000000E+00 alpha(00000442)=0.000000000000000E+00 beta (00000443)=0.124369439076634E+02 gamma(00000443)=0.124369439076634E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 443 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000443)=0.000000000000000E+00 beta (00000444)=0.136621724426676E+02 gamma(00000444)=0.136621724426676E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 444 z1= 1 0.600733267861889E-03 0.000000000000000E+00 z1= 2 -.621950560776270E-07 0.000000000000000E+00 z1= 3 -.870360899454456E-09 0.000000000000000E+00 alpha(00000444)=0.000000000000000E+00 beta (00000445)=0.133725504695665E+02 gamma(00000445)=0.133725504695665E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 445 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000445)=0.000000000000000E+00 beta (00000446)=0.136014204885003E+02 gamma(00000446)=0.136014204885003E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 446 z1= 1 -.151055477372942E-03 0.000000000000000E+00 z1= 2 0.629025394114800E-07 0.000000000000000E+00 z1= 3 -.625234718057248E-09 0.000000000000000E+00 alpha(00000446)=0.000000000000000E+00 beta (00000447)=0.132624133592241E+02 gamma(00000447)=0.132624133592241E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 447 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000447)=0.000000000000000E+00 beta (00000448)=0.134194157477962E+02 gamma(00000448)=0.134194157477962E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 448 z1= 1 -.324626783047290E-03 0.000000000000000E+00 z1= 2 -.675485697949202E-07 0.000000000000000E+00 z1= 3 0.314562671472739E-08 0.000000000000000E+00 alpha(00000448)=0.000000000000000E+00 beta (00000449)=0.127773708397656E+02 gamma(00000449)=0.127773708397656E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 449 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000449)=0.000000000000000E+00 beta (00000450)=0.127258344270304E+02 gamma(00000450)=0.127258344270304E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 450 z1= 1 0.880207864802062E-03 0.000000000000000E+00 z1= 2 0.601740093632026E-07 0.000000000000000E+00 z1= 3 0.119877512685376E-08 0.000000000000000E+00 alpha(00000450)=0.000000000000000E+00 beta (00000451)=0.127864506734170E+02 gamma(00000451)=0.127864506734170E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 451 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000451)=0.000000000000000E+00 beta (00000452)=0.130950189001773E+02 gamma(00000452)=0.130950189001773E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 452 z1= 1 -.154537709889859E-02 0.000000000000000E+00 z1= 2 -.752851100601151E-07 0.000000000000000E+00 z1= 3 0.124219691493730E-07 0.000000000000000E+00 alpha(00000452)=0.000000000000000E+00 beta (00000453)=0.120367282748693E+02 gamma(00000453)=0.120367282748693E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 453 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000453)=0.000000000000000E+00 beta (00000454)=0.141557701216911E+02 gamma(00000454)=0.141557701216911E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 454 z1= 1 0.200390801961187E-02 0.000000000000000E+00 z1= 2 0.371808852985336E-07 0.000000000000000E+00 z1= 3 0.417087458635338E-08 0.000000000000000E+00 alpha(00000454)=0.000000000000000E+00 beta (00000455)=0.124677019944097E+02 gamma(00000455)=0.124677019944097E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 455 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000455)=0.000000000000000E+00 beta (00000456)=0.140793270136515E+02 gamma(00000456)=0.140793270136515E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 456 z1= 1 -.239083874732493E-02 0.000000000000000E+00 z1= 2 -.744916610305457E-07 0.000000000000000E+00 z1= 3 0.255548080604559E-07 0.000000000000000E+00 alpha(00000456)=0.000000000000000E+00 beta (00000457)=0.120419833418809E+02 gamma(00000457)=0.120419833418809E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 457 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000457)=0.000000000000000E+00 beta (00000458)=0.135178391516618E+02 gamma(00000458)=0.135178391516618E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 458 z1= 1 0.264425950950132E-02 0.000000000000000E+00 z1= 2 0.175083066482340E-07 0.000000000000000E+00 z1= 3 0.111215563042039E-07 0.000000000000000E+00 alpha(00000458)=0.000000000000000E+00 beta (00000459)=0.128580343268962E+02 gamma(00000459)=0.128580343268962E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 459 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000459)=0.000000000000000E+00 beta (00000460)=0.138709757317243E+02 gamma(00000460)=0.138709757317243E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 460 z1= 1 -.273701833317835E-02 0.000000000000000E+00 z1= 2 -.967631246405129E-07 0.000000000000000E+00 z1= 3 0.423180292966475E-07 0.000000000000000E+00 alpha(00000460)=0.000000000000000E+00 beta (00000461)=0.132473629864998E+02 gamma(00000461)=0.132473629864998E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 461 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000461)=0.000000000000000E+00 beta (00000462)=0.132676386601278E+02 gamma(00000462)=0.132676386601278E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 462 z1= 1 0.298460985579461E-02 0.000000000000000E+00 z1= 2 0.114347041791849E-07 0.000000000000000E+00 z1= 3 0.168053711176500E-07 0.000000000000000E+00 alpha(00000462)=0.000000000000000E+00 beta (00000463)=0.120800430403433E+02 gamma(00000463)=0.120800430403433E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 463 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000463)=0.000000000000000E+00 beta (00000464)=0.130828319745927E+02 gamma(00000464)=0.130828319745927E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 464 z1= 1 -.309875618255775E-02 0.000000000000000E+00 z1= 2 -.126648982777706E-06 0.000000000000000E+00 z1= 3 0.627507751881670E-07 0.000000000000000E+00 alpha(00000464)=0.000000000000000E+00 beta (00000465)=0.126855936397782E+02 gamma(00000465)=0.126855936397782E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 465 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000465)=0.000000000000000E+00 beta (00000466)=0.139465578952109E+02 gamma(00000466)=0.139465578952109E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 466 z1= 1 0.307831022495826E-02 0.000000000000000E+00 z1= 2 -.336406289435341E-07 0.000000000000000E+00 z1= 3 0.445982264840714E-07 0.000000000000000E+00 alpha(00000466)=0.000000000000000E+00 beta (00000467)=0.125908771553474E+02 gamma(00000467)=0.125908771553474E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 467 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000467)=0.000000000000000E+00 beta (00000468)=0.133320013133514E+02 gamma(00000468)=0.133320013133514E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 468 z1= 1 -.306580756579370E-02 0.000000000000000E+00 z1= 2 -.186654913559691E-06 0.000000000000000E+00 z1= 3 0.102546554502455E-06 0.000000000000000E+00 alpha(00000468)=0.000000000000000E+00 beta (00000469)=0.133491545950961E+02 gamma(00000469)=0.133491545950961E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 469 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000469)=0.000000000000000E+00 beta (00000470)=0.144080469991053E+02 gamma(00000470)=0.144080469991053E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 470 z1= 1 0.290207157191895E-02 0.000000000000000E+00 z1= 2 -.737764743242476E-07 0.000000000000000E+00 z1= 3 0.744160605508932E-07 0.000000000000000E+00 alpha(00000470)=0.000000000000000E+00 beta (00000471)=0.127156781383924E+02 gamma(00000471)=0.127156781383924E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 471 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000471)=0.000000000000000E+00 beta (00000472)=0.137626272572474E+02 gamma(00000472)=0.137626272572474E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 472 z1= 1 -.275839386751185E-02 0.000000000000000E+00 z1= 2 -.189385867030867E-06 0.000000000000000E+00 z1= 3 0.103420780385953E-06 0.000000000000000E+00 alpha(00000472)=0.000000000000000E+00 beta (00000473)=0.125206927873686E+02 gamma(00000473)=0.125206927873686E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 473 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000473)=0.000000000000000E+00 beta (00000474)=0.138828720206626E+02 gamma(00000474)=0.138828720206626E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 474 z1= 1 0.264718029595884E-02 0.000000000000000E+00 z1= 2 -.493249904913451E-07 0.000000000000000E+00 z1= 3 0.573041215542504E-07 0.000000000000000E+00 alpha(00000474)=0.000000000000000E+00 beta (00000475)=0.127354380797680E+02 gamma(00000475)=0.127354380797680E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 475 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000475)=0.000000000000000E+00 beta (00000476)=0.132813415391906E+02 gamma(00000476)=0.132813415391906E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 476 z1= 1 -.275203073721368E-02 0.000000000000000E+00 z1= 2 -.161021820697417E-06 0.000000000000000E+00 z1= 3 0.871240147572996E-07 0.000000000000000E+00 alpha(00000476)=0.000000000000000E+00 beta (00000477)=0.132535984834398E+02 gamma(00000477)=0.132535984834398E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 477 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000477)=0.000000000000000E+00 beta (00000478)=0.146142840292878E+02 gamma(00000478)=0.146142840292878E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 478 z1= 1 0.274437474991129E-02 0.000000000000000E+00 z1= 2 -.266944125580301E-07 0.000000000000000E+00 z1= 3 0.376661339931397E-07 0.000000000000000E+00 alpha(00000478)=0.000000000000000E+00 beta (00000479)=0.125283504110860E+02 gamma(00000479)=0.125283504110860E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 479 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000479)=0.000000000000000E+00 beta (00000480)=0.134190662498111E+02 gamma(00000480)=0.134190662498111E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 480 z1= 1 -.283569023777372E-02 0.000000000000000E+00 z1= 2 -.909548899174703E-07 0.000000000000000E+00 z1= 3 0.462104667498691E-07 0.000000000000000E+00 alpha(00000480)=0.000000000000000E+00 beta (00000481)=0.124980256833603E+02 gamma(00000481)=0.124980256833603E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 481 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000481)=0.000000000000000E+00 beta (00000482)=0.136670850395748E+02 gamma(00000482)=0.136670850395748E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 482 z1= 1 0.277808189736329E-02 0.000000000000000E+00 z1= 2 0.326706741425944E-07 0.000000000000000E+00 z1= 3 -.601292566323845E-08 0.000000000000000E+00 alpha(00000482)=0.000000000000000E+00 beta (00000483)=0.125765775159077E+02 gamma(00000483)=0.125765775159077E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 483 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000483)=0.000000000000000E+00 beta (00000484)=0.138397027766468E+02 gamma(00000484)=0.138397027766468E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 484 z1= 1 -.275862771852226E-02 0.000000000000000E+00 z1= 2 -.167152472796243E-07 0.000000000000000E+00 z1= 3 -.198415761170365E-08 0.000000000000000E+00 alpha(00000484)=0.000000000000000E+00 beta (00000485)=0.128958186274822E+02 gamma(00000485)=0.128958186274822E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 485 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000485)=0.000000000000000E+00 beta (00000486)=0.134892316173655E+02 gamma(00000486)=0.134892316173655E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 486 z1= 1 0.290806478886054E-02 0.000000000000000E+00 z1= 2 0.807413749258183E-07 0.000000000000000E+00 z1= 3 -.399716422078990E-07 0.000000000000000E+00 alpha(00000486)=0.000000000000000E+00 beta (00000487)=0.124890714051323E+02 gamma(00000487)=0.124890714051323E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 487 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000487)=0.000000000000000E+00 beta (00000488)=0.132542673605848E+02 gamma(00000488)=0.132542673605848E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 488 z1= 1 -.302336538516835E-02 0.000000000000000E+00 z1= 2 0.645288906770541E-07 0.000000000000000E+00 z1= 3 -.530058275403488E-07 0.000000000000000E+00 alpha(00000488)=0.000000000000000E+00 beta (00000489)=0.128566524378107E+02 gamma(00000489)=0.128566524378107E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 489 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000489)=0.000000000000000E+00 beta (00000490)=0.137566921057673E+02 gamma(00000490)=0.137566921057673E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 490 z1= 1 0.308888244634246E-02 0.000000000000000E+00 z1= 2 0.148097424659648E-06 0.000000000000000E+00 z1= 3 -.880235701738378E-07 0.000000000000000E+00 alpha(00000490)=0.000000000000000E+00 beta (00000491)=0.130989085449932E+02 gamma(00000491)=0.130989085449932E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 491 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000491)=0.000000000000000E+00 beta (00000492)=0.128876430528797E+02 gamma(00000492)=0.128876430528797E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 492 z1= 1 -.342136158908035E-02 0.000000000000000E+00 z1= 2 0.157698466345287E-06 0.000000000000000E+00 z1= 3 -.112056647614905E-06 0.000000000000000E+00 alpha(00000492)=0.000000000000000E+00 beta (00000493)=0.123004963639200E+02 gamma(00000493)=0.123004963639200E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 493 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000493)=0.000000000000000E+00 beta (00000494)=0.141903002408846E+02 gamma(00000494)=0.141903002408846E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 494 z1= 1 0.317784958353149E-02 0.000000000000000E+00 z1= 2 0.247507927455398E-06 0.000000000000000E+00 z1= 3 -.158231594170756E-06 0.000000000000000E+00 alpha(00000494)=0.000000000000000E+00 beta (00000495)=0.120171467058784E+02 gamma(00000495)=0.120171467058784E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 495 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000495)=0.000000000000000E+00 beta (00000496)=0.139502535442313E+02 gamma(00000496)=0.139502535442313E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 496 z1= 1 -.291281621324683E-02 0.000000000000000E+00 z1= 2 0.337938336088077E-06 0.000000000000000E+00 z1= 3 -.226470449945257E-06 0.000000000000000E+00 alpha(00000496)=0.000000000000000E+00 beta (00000497)=0.125079761908836E+02 gamma(00000497)=0.125079761908836E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 497 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000497)=0.000000000000000E+00 beta (00000498)=0.137672962620982E+02 gamma(00000498)=0.137672962620982E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 498 z1= 1 0.273811617718792E-02 0.000000000000000E+00 z1= 2 0.430848379729364E-06 0.000000000000000E+00 z1= 3 -.283005338000885E-06 0.000000000000000E+00 alpha(00000498)=0.000000000000000E+00 beta (00000499)=0.121680503014387E+02 gamma(00000499)=0.121680503014387E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 499 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000499)=0.000000000000000E+00 beta (00000500)=0.135295516011163E+02 gamma(00000500)=0.135295516011163E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 500 z1= 1 -.257981959294285E-02 0.000000000000000E+00 z1= 2 0.628341009910327E-06 0.000000000000000E+00 z1= 3 -.417144411884746E-06 0.000000000000000E+00 alpha(00000500)=0.000000000000000E+00 beta (00000501)=0.128181336316831E+02 gamma(00000501)=0.128181336316831E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Norm of initial Lanczos vectors= 0.939778516313207 Starting Lanczos loop 2 Lanczos iteration: 1 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal alpha(00000001)=0.000000000000000E+00 beta (00000002)=0.199314513641442E+01 gamma(00000002)=0.199314513641442E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 2 z1= 1 -.790043077265358E-07 0.000000000000000E+00 z1= 2 0.629699724945927E+00 0.000000000000000E+00 z1= 3 -.322279402255755E-07 0.000000000000000E+00 alpha(00000002)=0.000000000000000E+00 beta (00000003)=0.670063129961676E+01 gamma(00000003)=0.670063129961676E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 3 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000003)=0.000000000000000E+00 beta (00000004)=0.145136733215085E+02 gamma(00000004)=0.145136733215085E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 4 z1= 1 0.446110372883009E-07 0.000000000000000E+00 z1= 2 -.232649447271527E+00 0.000000000000000E+00 z1= 3 0.939671323011652E-08 0.000000000000000E+00 alpha(00000004)=0.000000000000000E+00 beta (00000005)=0.122818074960053E+02 gamma(00000005)=0.122818074960053E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 5 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000005)=0.000000000000000E+00 beta (00000006)=0.140748547343379E+02 gamma(00000006)=0.140748547343379E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 6 z1= 1 -.356039938399777E-07 0.000000000000000E+00 z1= 2 0.180582990974725E+00 0.000000000000000E+00 z1= 3 -.776281559704012E-08 0.000000000000000E+00 alpha(00000006)=0.000000000000000E+00 beta (00000007)=0.125865103251421E+02 gamma(00000007)=0.125865103251421E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 7 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000007)=0.000000000000000E+00 beta (00000008)=0.137410782372369E+02 gamma(00000008)=0.137410782372369E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 8 z1= 1 0.310947534708575E-07 0.000000000000000E+00 z1= 2 -.152686406487598E+00 0.000000000000000E+00 z1= 3 0.769016725787278E-08 0.000000000000000E+00 alpha(00000008)=0.000000000000000E+00 beta (00000009)=0.127728858892724E+02 gamma(00000009)=0.127728858892724E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 9 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000009)=0.000000000000000E+00 beta (00000010)=0.137004256942849E+02 gamma(00000010)=0.137004256942849E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 10 z1= 1 -.286804814021366E-07 0.000000000000000E+00 z1= 2 0.134159731473548E+00 0.000000000000000E+00 z1= 3 -.128613117352308E-07 0.000000000000000E+00 alpha(00000010)=0.000000000000000E+00 beta (00000011)=0.128681749823308E+02 gamma(00000011)=0.128681749823308E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 11 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000011)=0.000000000000000E+00 beta (00000012)=0.137106674933334E+02 gamma(00000012)=0.137106674933334E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 12 z1= 1 0.280856611144936E-07 0.000000000000000E+00 z1= 2 -.119965532199319E+00 0.000000000000000E+00 z1= 3 0.210782780987436E-07 0.000000000000000E+00 alpha(00000012)=0.000000000000000E+00 beta (00000013)=0.128417726580712E+02 gamma(00000013)=0.128417726580712E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 13 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000013)=0.000000000000000E+00 beta (00000014)=0.137011508971301E+02 gamma(00000014)=0.137011508971301E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 14 z1= 1 -.290386115544064E-07 0.000000000000000E+00 z1= 2 0.107900585540801E+00 0.000000000000000E+00 z1= 3 -.314592966751829E-07 0.000000000000000E+00 alpha(00000014)=0.000000000000000E+00 beta (00000015)=0.128940308437528E+02 gamma(00000015)=0.128940308437528E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 15 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000015)=0.000000000000000E+00 beta (00000016)=0.137440784219033E+02 gamma(00000016)=0.137440784219033E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 16 z1= 1 0.310396994639313E-07 0.000000000000000E+00 z1= 2 -.976649429606703E-01 0.000000000000000E+00 z1= 3 0.413354135196534E-07 0.000000000000000E+00 alpha(00000016)=0.000000000000000E+00 beta (00000017)=0.128587725567707E+02 gamma(00000017)=0.128587725567707E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 17 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000017)=0.000000000000000E+00 beta (00000018)=0.135691730910655E+02 gamma(00000018)=0.135691730910655E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 18 z1= 1 -.343241087054705E-07 0.000000000000000E+00 z1= 2 0.896248881310645E-01 0.000000000000000E+00 z1= 3 -.510747138609017E-07 0.000000000000000E+00 alpha(00000018)=0.000000000000000E+00 beta (00000019)=0.127885914551852E+02 gamma(00000019)=0.127885914551852E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 19 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000019)=0.000000000000000E+00 beta (00000020)=0.135638217985383E+02 gamma(00000020)=0.135638217985383E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 20 z1= 1 0.373395274873289E-07 0.000000000000000E+00 z1= 2 -.821469837889522E-01 0.000000000000000E+00 z1= 3 0.584579802411249E-07 0.000000000000000E+00 alpha(00000020)=0.000000000000000E+00 beta (00000021)=0.128362049828420E+02 gamma(00000021)=0.128362049828420E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 21 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000021)=0.000000000000000E+00 beta (00000022)=0.136591761448323E+02 gamma(00000022)=0.136591761448323E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 22 z1= 1 -.396585117965961E-07 0.000000000000000E+00 z1= 2 0.752871093680645E-01 0.000000000000000E+00 z1= 3 -.630281788742892E-07 0.000000000000000E+00 alpha(00000022)=0.000000000000000E+00 beta (00000023)=0.129862393364179E+02 gamma(00000023)=0.129862393364179E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 23 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000023)=0.000000000000000E+00 beta (00000024)=0.134425179491838E+02 gamma(00000024)=0.134425179491838E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 24 z1= 1 0.423162891238088E-07 0.000000000000000E+00 z1= 2 -.711506453147521E-01 0.000000000000000E+00 z1= 3 0.675909671894888E-07 0.000000000000000E+00 alpha(00000024)=0.000000000000000E+00 beta (00000025)=0.126824224380708E+02 gamma(00000025)=0.126824224380708E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 25 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000025)=0.000000000000000E+00 beta (00000026)=0.137714872490347E+02 gamma(00000026)=0.137714872490347E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 26 z1= 1 -.426476923741370E-07 0.000000000000000E+00 z1= 2 0.642709482090714E-01 0.000000000000000E+00 z1= 3 -.668864585012851E-07 0.000000000000000E+00 alpha(00000026)=0.000000000000000E+00 beta (00000027)=0.130491941218255E+02 gamma(00000027)=0.130491941218255E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 27 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000027)=0.000000000000000E+00 beta (00000028)=0.135068062144363E+02 gamma(00000028)=0.135068062144363E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 28 z1= 1 0.449924136367713E-07 0.000000000000000E+00 z1= 2 -.610285415190230E-01 0.000000000000000E+00 z1= 3 0.686558994317861E-07 0.000000000000000E+00 alpha(00000028)=0.000000000000000E+00 beta (00000029)=0.130079366565337E+02 gamma(00000029)=0.130079366565337E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 29 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000029)=0.000000000000000E+00 beta (00000030)=0.137016566865608E+02 gamma(00000030)=0.137016566865608E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 30 z1= 1 -.475841335639826E-07 0.000000000000000E+00 z1= 2 0.570654625965890E-01 0.000000000000000E+00 z1= 3 -.695889864389145E-07 0.000000000000000E+00 alpha(00000030)=0.000000000000000E+00 beta (00000031)=0.128552398426000E+02 gamma(00000031)=0.128552398426000E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 31 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000031)=0.000000000000000E+00 beta (00000032)=0.135894781411509E+02 gamma(00000032)=0.135894781411509E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 32 z1= 1 0.517452876120511E-07 0.000000000000000E+00 z1= 2 -.532518451065526E-01 0.000000000000000E+00 z1= 3 0.713904651545195E-07 0.000000000000000E+00 alpha(00000032)=0.000000000000000E+00 beta (00000033)=0.128204747329435E+02 gamma(00000033)=0.128204747329435E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 33 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000033)=0.000000000000000E+00 beta (00000034)=0.137184806461678E+02 gamma(00000034)=0.137184806461678E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 34 z1= 1 -.564398989922471E-07 0.000000000000000E+00 z1= 2 0.491434295427229E-01 0.000000000000000E+00 z1= 3 -.730108220827700E-07 0.000000000000000E+00 alpha(00000034)=0.000000000000000E+00 beta (00000035)=0.126970618794771E+02 gamma(00000035)=0.126970618794771E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 35 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000035)=0.000000000000000E+00 beta (00000036)=0.133797820049250E+02 gamma(00000036)=0.133797820049250E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 36 z1= 1 0.641185345616468E-07 0.000000000000000E+00 z1= 2 -.460173321633378E-01 0.000000000000000E+00 z1= 3 0.776214843073420E-07 0.000000000000000E+00 alpha(00000036)=0.000000000000000E+00 beta (00000037)=0.129598330059239E+02 gamma(00000037)=0.129598330059239E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 37 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000037)=0.000000000000000E+00 beta (00000038)=0.134637156521308E+02 gamma(00000038)=0.134637156521308E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 38 z1= 1 -.735959083866117E-07 0.000000000000000E+00 z1= 2 0.437619338173536E-01 0.000000000000000E+00 z1= 3 -.853215744205040E-07 0.000000000000000E+00 alpha(00000038)=0.000000000000000E+00 beta (00000039)=0.129519589692445E+02 gamma(00000039)=0.129519589692445E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 39 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000039)=0.000000000000000E+00 beta (00000040)=0.134361824795856E+02 gamma(00000040)=0.134361824795856E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 40 z1= 1 0.837562418795623E-07 0.000000000000000E+00 z1= 2 -.417116798193467E-01 0.000000000000000E+00 z1= 3 0.937906982885831E-07 0.000000000000000E+00 alpha(00000040)=0.000000000000000E+00 beta (00000041)=0.128131240123313E+02 gamma(00000041)=0.128131240123313E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 41 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000041)=0.000000000000000E+00 beta (00000042)=0.136904434478483E+02 gamma(00000042)=0.136904434478483E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 42 z1= 1 -.918024995882893E-07 0.000000000000000E+00 z1= 2 0.385859641654756E-01 0.000000000000000E+00 z1= 3 -.993487103335446E-07 0.000000000000000E+00 alpha(00000042)=0.000000000000000E+00 beta (00000043)=0.127838983724361E+02 gamma(00000043)=0.127838983724361E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 43 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000043)=0.000000000000000E+00 beta (00000044)=0.135912163106819E+02 gamma(00000044)=0.135912163106819E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 44 z1= 1 0.996496452593948E-07 0.000000000000000E+00 z1= 2 -.358746763879996E-01 0.000000000000000E+00 z1= 3 0.105661013679367E-06 0.000000000000000E+00 alpha(00000044)=0.000000000000000E+00 beta (00000045)=0.125361808772060E+02 gamma(00000045)=0.125361808772060E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 45 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000045)=0.000000000000000E+00 beta (00000046)=0.133760143774021E+02 gamma(00000046)=0.133760143774021E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 46 z1= 1 -.106244767486378E-06 0.000000000000000E+00 z1= 2 0.331846479472728E-01 0.000000000000000E+00 z1= 3 -.112202687678519E-06 0.000000000000000E+00 alpha(00000046)=0.000000000000000E+00 beta (00000047)=0.125069514817964E+02 gamma(00000047)=0.125069514817964E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 47 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000047)=0.000000000000000E+00 beta (00000048)=0.136080031791310E+02 gamma(00000048)=0.136080031791310E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 48 z1= 1 0.109390251344134E-06 0.000000000000000E+00 z1= 2 -.300255121173719E-01 0.000000000000000E+00 z1= 3 0.116310517101761E-06 0.000000000000000E+00 alpha(00000048)=0.000000000000000E+00 beta (00000049)=0.131223659359952E+02 gamma(00000049)=0.131223659359952E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 49 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000049)=0.000000000000000E+00 beta (00000050)=0.138460099844389E+02 gamma(00000050)=0.138460099844389E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 50 z1= 1 -.114128454738877E-06 0.000000000000000E+00 z1= 2 0.280696375357226E-01 0.000000000000000E+00 z1= 3 -.122678381095327E-06 0.000000000000000E+00 alpha(00000050)=0.000000000000000E+00 beta (00000051)=0.127731423396725E+02 gamma(00000051)=0.127731423396725E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 51 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000051)=0.000000000000000E+00 beta (00000052)=0.133798779513896E+02 gamma(00000052)=0.133798779513896E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 52 z1= 1 0.118791854276934E-06 0.000000000000000E+00 z1= 2 -.264228699529384E-01 0.000000000000000E+00 z1= 3 0.129005256450303E-06 0.000000000000000E+00 alpha(00000052)=0.000000000000000E+00 beta (00000053)=0.126315014091530E+02 gamma(00000053)=0.126315014091530E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 53 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000053)=0.000000000000000E+00 beta (00000054)=0.132873852999306E+02 gamma(00000054)=0.132873852999306E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 54 z1= 1 -.120545069494035E-06 0.000000000000000E+00 z1= 2 0.247454910281710E-01 0.000000000000000E+00 z1= 3 -.132727243200412E-06 0.000000000000000E+00 alpha(00000054)=0.000000000000000E+00 beta (00000055)=0.133543409587930E+02 gamma(00000055)=0.133543409587930E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 55 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000055)=0.000000000000000E+00 beta (00000056)=0.135611651449432E+02 gamma(00000056)=0.135611651449432E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 56 z1= 1 0.125977088665311E-06 0.000000000000000E+00 z1= 2 -.240545791496991E-01 0.000000000000000E+00 z1= 3 0.141076376670394E-06 0.000000000000000E+00 alpha(00000056)=0.000000000000000E+00 beta (00000057)=0.131772750506366E+02 gamma(00000057)=0.131772750506366E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 57 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000057)=0.000000000000000E+00 beta (00000058)=0.132235066381283E+02 gamma(00000058)=0.132235066381283E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 58 z1= 1 -.133008074783281E-06 0.000000000000000E+00 z1= 2 0.236685549953153E-01 0.000000000000000E+00 z1= 3 -.151597356254216E-06 0.000000000000000E+00 alpha(00000058)=0.000000000000000E+00 beta (00000059)=0.127640905125642E+02 gamma(00000059)=0.127640905125642E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 59 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000059)=0.000000000000000E+00 beta (00000060)=0.136257160726290E+02 gamma(00000060)=0.136257160726290E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 60 z1= 1 0.130078703736332E-06 0.000000000000000E+00 z1= 2 -.218998881483948E-01 0.000000000000000E+00 z1= 3 0.151560905245718E-06 0.000000000000000E+00 alpha(00000060)=0.000000000000000E+00 beta (00000061)=0.132790717858904E+02 gamma(00000061)=0.132790717858904E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 61 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000061)=0.000000000000000E+00 beta (00000062)=0.139030702721106E+02 gamma(00000062)=0.139030702721106E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 62 z1= 1 -.129165234518530E-06 0.000000000000000E+00 z1= 2 0.206469379424336E-01 0.000000000000000E+00 z1= 3 -.154147008317465E-06 0.000000000000000E+00 alpha(00000062)=0.000000000000000E+00 beta (00000063)=0.131183051728761E+02 gamma(00000063)=0.131183051728761E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 63 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000063)=0.000000000000000E+00 beta (00000064)=0.135405068496676E+02 gamma(00000064)=0.135405068496676E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 64 z1= 1 0.130050657459659E-06 0.000000000000000E+00 z1= 2 -.197046222630951E-01 0.000000000000000E+00 z1= 3 0.159442683667538E-06 0.000000000000000E+00 alpha(00000064)=0.000000000000000E+00 beta (00000065)=0.125391289946244E+02 gamma(00000065)=0.125391289946244E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 65 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000065)=0.000000000000000E+00 beta (00000066)=0.134390307560694E+02 gamma(00000066)=0.134390307560694E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 66 z1= 1 -.126859562793805E-06 0.000000000000000E+00 z1= 2 0.181130921072045E-01 0.000000000000000E+00 z1= 3 -.160000063120474E-06 0.000000000000000E+00 alpha(00000066)=0.000000000000000E+00 beta (00000067)=0.132140237126926E+02 gamma(00000067)=0.132140237126926E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 67 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000067)=0.000000000000000E+00 beta (00000068)=0.138620815099316E+02 gamma(00000068)=0.138620815099316E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 68 z1= 1 0.126741309848175E-06 0.000000000000000E+00 z1= 2 -.171057464033828E-01 0.000000000000000E+00 z1= 3 0.162877575722340E-06 0.000000000000000E+00 alpha(00000068)=0.000000000000000E+00 beta (00000069)=0.130348425014813E+02 gamma(00000069)=0.130348425014813E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 69 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000069)=0.000000000000000E+00 beta (00000070)=0.133201133948262E+02 gamma(00000070)=0.133201133948262E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 70 z1= 1 -.130513143857362E-06 0.000000000000000E+00 z1= 2 0.165989896173604E-01 0.000000000000000E+00 z1= 3 -.170719879840275E-06 0.000000000000000E+00 alpha(00000070)=0.000000000000000E+00 beta (00000071)=0.128104084770361E+02 gamma(00000071)=0.128104084770361E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 71 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000071)=0.000000000000000E+00 beta (00000072)=0.139896048739943E+02 gamma(00000072)=0.139896048739943E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 72 z1= 1 0.126386486439672E-06 0.000000000000000E+00 z1= 2 -.150836815868346E-01 0.000000000000000E+00 z1= 3 0.168316025313546E-06 0.000000000000000E+00 alpha(00000072)=0.000000000000000E+00 beta (00000073)=0.128218335685808E+02 gamma(00000073)=0.128218335685808E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 73 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000073)=0.000000000000000E+00 beta (00000074)=0.132875919993163E+02 gamma(00000074)=0.132875919993163E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 74 z1= 1 -.129081969672123E-06 0.000000000000000E+00 z1= 2 0.144443740432484E-01 0.000000000000000E+00 z1= 3 -.174757921681500E-06 0.000000000000000E+00 alpha(00000074)=0.000000000000000E+00 beta (00000075)=0.122804827883956E+02 gamma(00000075)=0.122804827883956E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 75 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000075)=0.000000000000000E+00 beta (00000076)=0.134548953845530E+02 gamma(00000076)=0.134548953845530E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 76 z1= 1 0.125865509033492E-06 0.000000000000000E+00 z1= 2 -.131039024875661E-01 0.000000000000000E+00 z1= 3 0.172070759605421E-06 0.000000000000000E+00 alpha(00000076)=0.000000000000000E+00 beta (00000077)=0.128673814824881E+02 gamma(00000077)=0.128673814824881E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 77 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000077)=0.000000000000000E+00 beta (00000078)=0.139740047048490E+02 gamma(00000078)=0.139740047048490E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 78 z1= 1 -.124264608693248E-06 0.000000000000000E+00 z1= 2 0.120552364920151E-01 0.000000000000000E+00 z1= 3 -.172218867814603E-06 0.000000000000000E+00 alpha(00000078)=0.000000000000000E+00 beta (00000079)=0.127688486400079E+02 gamma(00000079)=0.127688486400079E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 79 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000079)=0.000000000000000E+00 beta (00000080)=0.134060378524941E+02 gamma(00000080)=0.134060378524941E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 80 z1= 1 0.126962459694874E-06 0.000000000000000E+00 z1= 2 -.115191275729535E-01 0.000000000000000E+00 z1= 3 0.179191734048342E-06 0.000000000000000E+00 alpha(00000080)=0.000000000000000E+00 beta (00000081)=0.127014908325623E+02 gamma(00000081)=0.127014908325623E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 81 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000081)=0.000000000000000E+00 beta (00000082)=0.140476866634477E+02 gamma(00000082)=0.140476866634477E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 82 z1= 1 -.123610269350989E-06 0.000000000000000E+00 z1= 2 0.104894624043075E-01 0.000000000000000E+00 z1= 3 -.176376331190555E-06 0.000000000000000E+00 alpha(00000082)=0.000000000000000E+00 beta (00000083)=0.128227081433574E+02 gamma(00000083)=0.128227081433574E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 83 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000083)=0.000000000000000E+00 beta (00000084)=0.131465151656905E+02 gamma(00000084)=0.131465151656905E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 84 z1= 1 0.130844340652178E-06 0.000000000000000E+00 z1= 2 -.103253680653668E-01 0.000000000000000E+00 z1= 3 0.186472579953036E-06 0.000000000000000E+00 alpha(00000084)=0.000000000000000E+00 beta (00000085)=0.129169623472291E+02 gamma(00000085)=0.129169623472291E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 85 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000085)=0.000000000000000E+00 beta (00000086)=0.141724392150560E+02 gamma(00000086)=0.141724392150560E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 86 z1= 1 -.129313775570818E-06 0.000000000000000E+00 z1= 2 0.937915169906799E-02 0.000000000000000E+00 z1= 3 -.183793388266822E-06 0.000000000000000E+00 alpha(00000086)=0.000000000000000E+00 beta (00000087)=0.126042123026320E+02 gamma(00000087)=0.126042123026320E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 87 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000087)=0.000000000000000E+00 beta (00000088)=0.133572267857064E+02 gamma(00000088)=0.133572267857064E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 88 z1= 1 0.135819881517778E-06 0.000000000000000E+00 z1= 2 -.866887788010403E-02 0.000000000000000E+00 z1= 3 0.191430443445887E-06 0.000000000000000E+00 alpha(00000088)=0.000000000000000E+00 beta (00000089)=0.129319547169416E+02 gamma(00000089)=0.129319547169416E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 89 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000089)=0.000000000000000E+00 beta (00000090)=0.137666349379574E+02 gamma(00000090)=0.137666349379574E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 90 z1= 1 -.140316060638201E-06 0.000000000000000E+00 z1= 2 0.790768835504636E-02 0.000000000000000E+00 z1= 3 -.196502800056144E-06 0.000000000000000E+00 alpha(00000090)=0.000000000000000E+00 beta (00000091)=0.125045603393475E+02 gamma(00000091)=0.125045603393475E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 91 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000091)=0.000000000000000E+00 beta (00000092)=0.129404248070322E+02 gamma(00000092)=0.129404248070322E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 92 z1= 1 0.149264349798197E-06 0.000000000000000E+00 z1= 2 -.741078967137379E-02 0.000000000000000E+00 z1= 3 0.208849764317582E-06 0.000000000000000E+00 alpha(00000092)=0.000000000000000E+00 beta (00000093)=0.134311025506692E+02 gamma(00000093)=0.134311025506692E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 93 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000093)=0.000000000000000E+00 beta (00000094)=0.132437635231099E+02 gamma(00000094)=0.132437635231099E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 94 z1= 1 -.163987053129842E-06 0.000000000000000E+00 z1= 2 0.733578669202683E-02 0.000000000000000E+00 z1= 3 -.229000161051864E-06 0.000000000000000E+00 alpha(00000094)=0.000000000000000E+00 beta (00000095)=0.124429544019852E+02 gamma(00000095)=0.124429544019852E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 95 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000095)=0.000000000000000E+00 beta (00000096)=0.130304948140391E+02 gamma(00000096)=0.130304948140391E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 96 z1= 1 0.170217389803932E-06 0.000000000000000E+00 z1= 2 -.684847776611897E-02 0.000000000000000E+00 z1= 3 0.237356493873421E-06 0.000000000000000E+00 alpha(00000096)=0.000000000000000E+00 beta (00000097)=0.127892153608393E+02 gamma(00000097)=0.127892153608393E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 97 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000097)=0.000000000000000E+00 beta (00000098)=0.128270168898352E+02 gamma(00000098)=0.128270168898352E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 98 z1= 1 -.184036211580037E-06 0.000000000000000E+00 z1= 2 0.663203303381391E-02 0.000000000000000E+00 z1= 3 -.257095863842615E-06 0.000000000000000E+00 alpha(00000098)=0.000000000000000E+00 beta (00000099)=0.121409223362765E+02 gamma(00000099)=0.121409223362765E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 99 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000099)=0.000000000000000E+00 beta (00000100)=0.136038315211714E+02 gamma(00000100)=0.136038315211714E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 100 z1= 1 0.178019563418469E-06 0.000000000000000E+00 z1= 2 -.578329815168586E-02 0.000000000000000E+00 z1= 3 0.247074156359262E-06 0.000000000000000E+00 alpha(00000100)=0.000000000000000E+00 beta (00000101)=0.129656539488817E+02 gamma(00000101)=0.129656539488817E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 101 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000101)=0.000000000000000E+00 beta (00000102)=0.131118308841364E+02 gamma(00000102)=0.131118308841364E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 102 z1= 1 -.192604364256544E-06 0.000000000000000E+00 z1= 2 0.575069424898166E-02 0.000000000000000E+00 z1= 3 -.262566874134295E-06 0.000000000000000E+00 alpha(00000102)=0.000000000000000E+00 beta (00000103)=0.136938629624350E+02 gamma(00000103)=0.136938629624350E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 103 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000103)=0.000000000000000E+00 beta (00000104)=0.133882041915080E+02 gamma(00000104)=0.133882041915080E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 104 z1= 1 0.213556375944007E-06 0.000000000000000E+00 z1= 2 -.609540617369077E-02 0.000000000000000E+00 z1= 3 0.284720526602696E-06 0.000000000000000E+00 alpha(00000104)=0.000000000000000E+00 beta (00000105)=0.130441765688506E+02 gamma(00000105)=0.130441765688506E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 105 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000105)=0.000000000000000E+00 beta (00000106)=0.141232659505525E+02 gamma(00000106)=0.141232659505525E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 106 z1= 1 -.213446863027043E-06 0.000000000000000E+00 z1= 2 0.588739512320269E-02 0.000000000000000E+00 z1= 3 -.279222051589140E-06 0.000000000000000E+00 alpha(00000106)=0.000000000000000E+00 beta (00000107)=0.131966679762314E+02 gamma(00000107)=0.131966679762314E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 107 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000107)=0.000000000000000E+00 beta (00000108)=0.134607510696525E+02 gamma(00000108)=0.134607510696525E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 108 z1= 1 0.226745330423987E-06 0.000000000000000E+00 z1= 2 -.602261381533554E-02 0.000000000000000E+00 z1= 3 0.291839820934720E-06 0.000000000000000E+00 alpha(00000108)=0.000000000000000E+00 beta (00000109)=0.135930215760676E+02 gamma(00000109)=0.135930215760676E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 109 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000109)=0.000000000000000E+00 beta (00000110)=0.125435592351440E+02 gamma(00000110)=0.125435592351440E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 110 z1= 1 -.262878728626761E-06 0.000000000000000E+00 z1= 2 0.671350808823198E-02 0.000000000000000E+00 z1= 3 -.334911758642599E-06 0.000000000000000E+00 alpha(00000110)=0.000000000000000E+00 beta (00000111)=0.131064298538102E+02 gamma(00000111)=0.131064298538102E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 111 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000111)=0.000000000000000E+00 beta (00000112)=0.137148858777712E+02 gamma(00000112)=0.137148858777712E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 112 z1= 1 0.265750324460277E-06 0.000000000000000E+00 z1= 2 -.655040429883997E-02 0.000000000000000E+00 z1= 3 0.335511581696563E-06 0.000000000000000E+00 alpha(00000112)=0.000000000000000E+00 beta (00000113)=0.127404507389050E+02 gamma(00000113)=0.127404507389050E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 113 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000113)=0.000000000000000E+00 beta (00000114)=0.137207983432882E+02 gamma(00000114)=0.137207983432882E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 114 z1= 1 -.260528719375330E-06 0.000000000000000E+00 z1= 2 0.624098220669833E-02 0.000000000000000E+00 z1= 3 -.324366130008912E-06 0.000000000000000E+00 alpha(00000114)=0.000000000000000E+00 beta (00000115)=0.119984389774874E+02 gamma(00000115)=0.119984389774874E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 115 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000115)=0.000000000000000E+00 beta (00000116)=0.137000623041128E+02 gamma(00000116)=0.137000623041128E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 116 z1= 1 0.242566252050148E-06 0.000000000000000E+00 z1= 2 -.572374562159244E-02 0.000000000000000E+00 z1= 3 0.298158022407472E-06 0.000000000000000E+00 alpha(00000116)=0.000000000000000E+00 beta (00000117)=0.124256702946239E+02 gamma(00000117)=0.124256702946239E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 117 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000117)=0.000000000000000E+00 beta (00000118)=0.134796470609424E+02 gamma(00000118)=0.134796470609424E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 118 z1= 1 -.237574958689320E-06 0.000000000000000E+00 z1= 2 0.548267546638759E-02 0.000000000000000E+00 z1= 3 -.289332376869731E-06 0.000000000000000E+00 alpha(00000118)=0.000000000000000E+00 beta (00000119)=0.128590941263343E+02 gamma(00000119)=0.128590941263343E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 119 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000119)=0.000000000000000E+00 beta (00000120)=0.134053468253034E+02 gamma(00000120)=0.134053468253034E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 120 z1= 1 0.240082736907045E-06 0.000000000000000E+00 z1= 2 -.535944529103414E-02 0.000000000000000E+00 z1= 3 0.290058917070670E-06 0.000000000000000E+00 alpha(00000120)=0.000000000000000E+00 beta (00000121)=0.127605143234085E+02 gamma(00000121)=0.127605143234085E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 121 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000121)=0.000000000000000E+00 beta (00000122)=0.133447990528916E+02 gamma(00000122)=0.133447990528916E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 122 z1= 1 -.241201415103129E-06 0.000000000000000E+00 z1= 2 0.514309941050215E-02 0.000000000000000E+00 z1= 3 -.288787917568844E-06 0.000000000000000E+00 alpha(00000122)=0.000000000000000E+00 beta (00000123)=0.127224551821935E+02 gamma(00000123)=0.127224551821935E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 123 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000123)=0.000000000000000E+00 beta (00000124)=0.134570336455021E+02 gamma(00000124)=0.134570336455021E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 124 z1= 1 0.239234062193207E-06 0.000000000000000E+00 z1= 2 -.484972207572151E-02 0.000000000000000E+00 z1= 3 0.283120867488121E-06 0.000000000000000E+00 alpha(00000124)=0.000000000000000E+00 beta (00000125)=0.129005338763405E+02 gamma(00000125)=0.129005338763405E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 125 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000125)=0.000000000000000E+00 beta (00000126)=0.137360706341500E+02 gamma(00000126)=0.137360706341500E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 126 z1= 1 -.236002855725885E-06 0.000000000000000E+00 z1= 2 0.460510396492387E-02 0.000000000000000E+00 z1= 3 -.276652899723444E-06 0.000000000000000E+00 alpha(00000126)=0.000000000000000E+00 beta (00000127)=0.128192883502740E+02 gamma(00000127)=0.128192883502740E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 127 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000127)=0.000000000000000E+00 beta (00000128)=0.138278613381075E+02 gamma(00000128)=0.138278613381075E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 128 z1= 1 0.228844792055007E-06 0.000000000000000E+00 z1= 2 -.438246060515621E-02 0.000000000000000E+00 z1= 3 0.266166910680278E-06 0.000000000000000E+00 alpha(00000128)=0.000000000000000E+00 beta (00000129)=0.132954719807332E+02 gamma(00000129)=0.132954719807332E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 129 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000129)=0.000000000000000E+00 beta (00000130)=0.135447789436557E+02 gamma(00000130)=0.135447789436557E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 130 z1= 1 -.233556698055800E-06 0.000000000000000E+00 z1= 2 0.440976318886318E-02 0.000000000000000E+00 z1= 3 -.269819392244655E-06 0.000000000000000E+00 alpha(00000130)=0.000000000000000E+00 beta (00000131)=0.125749773641160E+02 gamma(00000131)=0.125749773641160E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 131 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000131)=0.000000000000000E+00 beta (00000132)=0.135691612103990E+02 gamma(00000132)=0.135691612103990E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 132 z1= 1 0.225210617694691E-06 0.000000000000000E+00 z1= 2 -.410269795298495E-02 0.000000000000000E+00 z1= 3 0.259647683603539E-06 0.000000000000000E+00 alpha(00000132)=0.000000000000000E+00 beta (00000133)=0.125411196051839E+02 gamma(00000133)=0.125411196051839E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 133 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000133)=0.000000000000000E+00 beta (00000134)=0.135110541289974E+02 gamma(00000134)=0.135110541289974E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 134 z1= 1 -.217966243222859E-06 0.000000000000000E+00 z1= 2 0.375441634629588E-02 0.000000000000000E+00 z1= 3 -.250742597963081E-06 0.000000000000000E+00 alpha(00000134)=0.000000000000000E+00 beta (00000135)=0.127015229425724E+02 gamma(00000135)=0.127015229425724E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 135 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000135)=0.000000000000000E+00 beta (00000136)=0.137731858715484E+02 gamma(00000136)=0.137731858715484E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 136 z1= 1 0.209855581956124E-06 0.000000000000000E+00 z1= 2 -.336088359978323E-02 0.000000000000000E+00 z1= 3 0.240516080617353E-06 0.000000000000000E+00 alpha(00000136)=0.000000000000000E+00 beta (00000137)=0.127543176285453E+02 gamma(00000137)=0.127543176285453E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 137 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000137)=0.000000000000000E+00 beta (00000138)=0.130998889715247E+02 gamma(00000138)=0.130998889715247E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 138 z1= 1 -.212077842606795E-06 0.000000000000000E+00 z1= 2 0.320287866410417E-02 0.000000000000000E+00 z1= 3 -.242389022261333E-06 0.000000000000000E+00 alpha(00000138)=0.000000000000000E+00 beta (00000139)=0.124440168646227E+02 gamma(00000139)=0.124440168646227E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 139 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000139)=0.000000000000000E+00 beta (00000140)=0.138474328037448E+02 gamma(00000140)=0.138474328037448E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 140 z1= 1 0.198974762723528E-06 0.000000000000000E+00 z1= 2 -.293328391857006E-02 0.000000000000000E+00 z1= 3 0.226019875017303E-06 0.000000000000000E+00 alpha(00000140)=0.000000000000000E+00 beta (00000141)=0.131458632439316E+02 gamma(00000141)=0.131458632439316E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 141 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000141)=0.000000000000000E+00 beta (00000142)=0.135271001083719E+02 gamma(00000142)=0.135271001083719E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 142 z1= 1 -.202653169459419E-06 0.000000000000000E+00 z1= 2 0.300418239694160E-02 0.000000000000000E+00 z1= 3 -.229708094237678E-06 0.000000000000000E+00 alpha(00000142)=0.000000000000000E+00 beta (00000143)=0.126296368966487E+02 gamma(00000143)=0.126296368966487E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 143 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000143)=0.000000000000000E+00 beta (00000144)=0.135905476654193E+02 gamma(00000144)=0.135905476654193E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 144 z1= 1 0.197475103760978E-06 0.000000000000000E+00 z1= 2 -.304592967587213E-02 0.000000000000000E+00 z1= 3 0.224364099576718E-06 0.000000000000000E+00 alpha(00000144)=0.000000000000000E+00 beta (00000145)=0.131395615163833E+02 gamma(00000145)=0.131395615163833E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 145 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000145)=0.000000000000000E+00 beta (00000146)=0.139085299803225E+02 gamma(00000146)=0.139085299803225E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 146 z1= 1 -.194819589783429E-06 0.000000000000000E+00 z1= 2 0.313632922273816E-02 0.000000000000000E+00 z1= 3 -.222620112625988E-06 0.000000000000000E+00 alpha(00000146)=0.000000000000000E+00 beta (00000147)=0.132398668393330E+02 gamma(00000147)=0.132398668393330E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 147 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000147)=0.000000000000000E+00 beta (00000148)=0.138453797368347E+02 gamma(00000148)=0.138453797368347E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 148 z1= 1 0.192278874405327E-06 0.000000000000000E+00 z1= 2 -.318849046014735E-02 0.000000000000000E+00 z1= 3 0.223385336731207E-06 0.000000000000000E+00 alpha(00000148)=0.000000000000000E+00 beta (00000149)=0.128467254241748E+02 gamma(00000149)=0.128467254241748E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 149 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000149)=0.000000000000000E+00 beta (00000150)=0.133348061382028E+02 gamma(00000150)=0.133348061382028E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 150 z1= 1 -.189785592736962E-06 0.000000000000000E+00 z1= 2 0.324327722059913E-02 0.000000000000000E+00 z1= 3 -.226227291697054E-06 0.000000000000000E+00 alpha(00000150)=0.000000000000000E+00 beta (00000151)=0.126505456617677E+02 gamma(00000151)=0.126505456617677E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 151 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000151)=0.000000000000000E+00 beta (00000152)=0.138852436966292E+02 gamma(00000152)=0.138852436966292E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 152 z1= 1 0.176213009066284E-06 0.000000000000000E+00 z1= 2 -.302711904779740E-02 0.000000000000000E+00 z1= 3 0.215928272128242E-06 0.000000000000000E+00 alpha(00000152)=0.000000000000000E+00 beta (00000153)=0.127834212885972E+02 gamma(00000153)=0.127834212885972E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 153 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000153)=0.000000000000000E+00 beta (00000154)=0.141175277579643E+02 gamma(00000154)=0.141175277579643E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 154 z1= 1 -.163439315715823E-06 0.000000000000000E+00 z1= 2 0.276116579157235E-02 0.000000000000000E+00 z1= 3 -.206148884119108E-06 0.000000000000000E+00 alpha(00000154)=0.000000000000000E+00 beta (00000155)=0.125123419398172E+02 gamma(00000155)=0.125123419398172E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 155 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000155)=0.000000000000000E+00 beta (00000156)=0.132693153901251E+02 gamma(00000156)=0.132693153901251E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 156 z1= 1 0.159924891771470E-06 0.000000000000000E+00 z1= 2 -.263250608729001E-02 0.000000000000000E+00 z1= 3 0.207484961396460E-06 0.000000000000000E+00 alpha(00000156)=0.000000000000000E+00 beta (00000157)=0.126048883261632E+02 gamma(00000157)=0.126048883261632E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 157 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000157)=0.000000000000000E+00 beta (00000158)=0.137949407049992E+02 gamma(00000158)=0.137949407049992E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 158 z1= 1 -.150776716488900E-06 0.000000000000000E+00 z1= 2 0.237102677402072E-02 0.000000000000000E+00 z1= 3 -.201166839061250E-06 0.000000000000000E+00 alpha(00000158)=0.000000000000000E+00 beta (00000159)=0.130584187527601E+02 gamma(00000159)=0.130584187527601E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 159 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000159)=0.000000000000000E+00 beta (00000160)=0.138031360735505E+02 gamma(00000160)=0.138031360735505E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 160 z1= 1 0.146230210335951E-06 0.000000000000000E+00 z1= 2 -.217730922166263E-02 0.000000000000000E+00 z1= 3 0.201983101239976E-06 0.000000000000000E+00 alpha(00000160)=0.000000000000000E+00 beta (00000161)=0.129234960980805E+02 gamma(00000161)=0.129234960980805E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 161 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000161)=0.000000000000000E+00 beta (00000162)=0.133298288862500E+02 gamma(00000162)=0.133298288862500E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 162 z1= 1 -.146018159139470E-06 0.000000000000000E+00 z1= 2 0.200128484430968E-02 0.000000000000000E+00 z1= 3 -.208577368233107E-06 0.000000000000000E+00 alpha(00000162)=0.000000000000000E+00 beta (00000163)=0.124682404393177E+02 gamma(00000163)=0.124682404393177E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 163 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000163)=0.000000000000000E+00 beta (00000164)=0.134658103220826E+02 gamma(00000164)=0.134658103220826E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 164 z1= 1 0.141419859993504E-06 0.000000000000000E+00 z1= 2 -.164556860966341E-02 0.000000000000000E+00 z1= 3 0.206164027580355E-06 0.000000000000000E+00 alpha(00000164)=0.000000000000000E+00 beta (00000165)=0.128624688908585E+02 gamma(00000165)=0.128624688908585E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 165 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000165)=0.000000000000000E+00 beta (00000166)=0.137346243115554E+02 gamma(00000166)=0.137346243115554E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 166 z1= 1 -.139623353486579E-06 0.000000000000000E+00 z1= 2 0.125846578805442E-02 0.000000000000000E+00 z1= 3 -.206310621561341E-06 0.000000000000000E+00 alpha(00000166)=0.000000000000000E+00 beta (00000167)=0.126784910683803E+02 gamma(00000167)=0.126784910683803E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 167 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000167)=0.000000000000000E+00 beta (00000168)=0.142370262025007E+02 gamma(00000168)=0.142370262025007E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 168 z1= 1 0.131624039573274E-06 0.000000000000000E+00 z1= 2 -.852396274396431E-03 0.000000000000000E+00 z1= 3 0.195697067773329E-06 0.000000000000000E+00 alpha(00000168)=0.000000000000000E+00 beta (00000169)=0.122884010510995E+02 gamma(00000169)=0.122884010510995E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 169 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000169)=0.000000000000000E+00 beta (00000170)=0.139332126915436E+02 gamma(00000170)=0.139332126915436E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 170 z1= 1 -.124777624761676E-06 0.000000000000000E+00 z1= 2 0.606187777261234E-03 0.000000000000000E+00 z1= 3 -.185022017859472E-06 0.000000000000000E+00 alpha(00000170)=0.000000000000000E+00 beta (00000171)=0.130755801907957E+02 gamma(00000171)=0.130755801907957E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 171 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000171)=0.000000000000000E+00 beta (00000172)=0.136261971067049E+02 gamma(00000172)=0.136261971067049E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 172 z1= 1 0.127767101044517E-06 0.000000000000000E+00 z1= 2 -.481801353696592E-03 0.000000000000000E+00 z1= 3 0.190587072635795E-06 0.000000000000000E+00 alpha(00000172)=0.000000000000000E+00 beta (00000173)=0.121894701321099E+02 gamma(00000173)=0.121894701321099E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 173 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000173)=0.000000000000000E+00 beta (00000174)=0.133774791100130E+02 gamma(00000174)=0.133774791100130E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 174 z1= 1 -.123492610699938E-06 0.000000000000000E+00 z1= 2 0.329033992326387E-03 0.000000000000000E+00 z1= 3 -.187356321664086E-06 0.000000000000000E+00 alpha(00000174)=0.000000000000000E+00 beta (00000175)=0.130321729113568E+02 gamma(00000175)=0.130321729113568E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 175 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000175)=0.000000000000000E+00 beta (00000176)=0.135964559315681E+02 gamma(00000176)=0.135964559315681E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 176 z1= 1 0.122662791006943E-06 0.000000000000000E+00 z1= 2 -.201460013187148E-03 0.000000000000000E+00 z1= 3 0.192117468742078E-06 0.000000000000000E+00 alpha(00000176)=0.000000000000000E+00 beta (00000177)=0.131049345581647E+02 gamma(00000177)=0.131049345581647E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 177 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000177)=0.000000000000000E+00 beta (00000178)=0.137484366522573E+02 gamma(00000178)=0.137484366522573E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 178 z1= 1 -.118921026848878E-06 0.000000000000000E+00 z1= 2 0.451954685805125E-04 0.000000000000000E+00 z1= 3 -.192880134088102E-06 0.000000000000000E+00 alpha(00000178)=0.000000000000000E+00 beta (00000179)=0.125767402561520E+02 gamma(00000179)=0.125767402561520E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 179 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000179)=0.000000000000000E+00 beta (00000180)=0.132901873256216E+02 gamma(00000180)=0.132901873256216E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 180 z1= 1 0.115520922932578E-06 0.000000000000000E+00 z1= 2 0.877488131872037E-04 0.000000000000000E+00 z1= 3 0.192913448022016E-06 0.000000000000000E+00 alpha(00000180)=0.000000000000000E+00 beta (00000181)=0.126737433823299E+02 gamma(00000181)=0.126737433823299E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 181 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000181)=0.000000000000000E+00 beta (00000182)=0.136833907857128E+02 gamma(00000182)=0.136833907857128E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 182 z1= 1 -.111281248509412E-06 0.000000000000000E+00 z1= 2 -.212026154336797E-03 0.000000000000000E+00 z1= 3 -.188575014008338E-06 0.000000000000000E+00 alpha(00000182)=0.000000000000000E+00 beta (00000183)=0.127712574218309E+02 gamma(00000183)=0.127712574218309E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 183 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000183)=0.000000000000000E+00 beta (00000184)=0.134436079703326E+02 gamma(00000184)=0.134436079703326E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 184 z1= 1 0.109703016392803E-06 0.000000000000000E+00 z1= 2 0.336381538491966E-03 0.000000000000000E+00 z1= 3 0.186688901141320E-06 0.000000000000000E+00 alpha(00000184)=0.000000000000000E+00 beta (00000185)=0.131257289661786E+02 gamma(00000185)=0.131257289661786E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 185 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000185)=0.000000000000000E+00 beta (00000186)=0.142025092397446E+02 gamma(00000186)=0.142025092397446E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 186 z1= 1 -.104736838828570E-06 0.000000000000000E+00 z1= 2 -.393599462744856E-03 0.000000000000000E+00 z1= 3 -.179655548970115E-06 0.000000000000000E+00 alpha(00000186)=0.000000000000000E+00 beta (00000187)=0.127865138493426E+02 gamma(00000187)=0.127865138493426E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 187 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000187)=0.000000000000000E+00 beta (00000188)=0.131985046871372E+02 gamma(00000188)=0.131985046871372E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 188 z1= 1 0.104521019138326E-06 0.000000000000000E+00 z1= 2 0.410911454684148E-03 0.000000000000000E+00 z1= 3 0.181204911401951E-06 0.000000000000000E+00 alpha(00000188)=0.000000000000000E+00 beta (00000189)=0.129108653996627E+02 gamma(00000189)=0.129108653996627E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 189 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000189)=0.000000000000000E+00 beta (00000190)=0.141431635873083E+02 gamma(00000190)=0.141431635873083E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 190 z1= 1 -.975765186666915E-07 0.000000000000000E+00 z1= 2 -.384925188311383E-03 0.000000000000000E+00 z1= 3 -.170191710494451E-06 0.000000000000000E+00 alpha(00000190)=0.000000000000000E+00 beta (00000191)=0.126098013366047E+02 gamma(00000191)=0.126098013366047E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 191 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000191)=0.000000000000000E+00 beta (00000192)=0.136884475118528E+02 gamma(00000192)=0.136884475118528E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 192 z1= 1 0.923132474680427E-07 0.000000000000000E+00 z1= 2 0.333020594178294E-03 0.000000000000000E+00 z1= 3 0.161995567154257E-06 0.000000000000000E+00 alpha(00000192)=0.000000000000000E+00 beta (00000193)=0.125495067387855E+02 gamma(00000193)=0.125495067387855E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 193 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000193)=0.000000000000000E+00 beta (00000194)=0.129665703734560E+02 gamma(00000194)=0.129665703734560E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 194 z1= 1 -.921087123500336E-07 0.000000000000000E+00 z1= 2 -.307289285477437E-03 0.000000000000000E+00 z1= 3 -.160901485108484E-06 0.000000000000000E+00 alpha(00000194)=0.000000000000000E+00 beta (00000195)=0.131997632116577E+02 gamma(00000195)=0.131997632116577E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 195 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000195)=0.000000000000000E+00 beta (00000196)=0.138207076166524E+02 gamma(00000196)=0.138207076166524E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 196 z1= 1 0.899057883809243E-07 0.000000000000000E+00 z1= 2 0.227623928659281E-03 0.000000000000000E+00 z1= 3 0.157394519203959E-06 0.000000000000000E+00 alpha(00000196)=0.000000000000000E+00 beta (00000197)=0.133772245659795E+02 gamma(00000197)=0.133772245659795E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 197 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000197)=0.000000000000000E+00 beta (00000198)=0.140061098945727E+02 gamma(00000198)=0.140061098945727E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 198 z1= 1 -.872776285991070E-07 0.000000000000000E+00 z1= 2 -.649727583717126E-04 0.000000000000000E+00 z1= 3 -.154343933955520E-06 0.000000000000000E+00 alpha(00000198)=0.000000000000000E+00 beta (00000199)=0.126385149457509E+02 gamma(00000199)=0.126385149457509E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 199 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000199)=0.000000000000000E+00 beta (00000200)=0.135378051066623E+02 gamma(00000200)=0.135378051066623E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 200 z1= 1 0.827551175346802E-07 0.000000000000000E+00 z1= 2 -.154782748515107E-03 0.000000000000000E+00 z1= 3 0.149881154524307E-06 0.000000000000000E+00 alpha(00000200)=0.000000000000000E+00 beta (00000201)=0.121675497786031E+02 gamma(00000201)=0.121675497786031E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 201 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000201)=0.000000000000000E+00 beta (00000202)=0.137941563295405E+02 gamma(00000202)=0.137941563295405E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 202 z1= 1 -.746941392158057E-07 0.000000000000000E+00 z1= 2 0.365538043659330E-03 0.000000000000000E+00 z1= 3 -.138839037456515E-06 0.000000000000000E+00 alpha(00000202)=0.000000000000000E+00 beta (00000203)=0.128273480872861E+02 gamma(00000203)=0.128273480872861E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 203 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000203)=0.000000000000000E+00 beta (00000204)=0.136965998456510E+02 gamma(00000204)=0.136965998456510E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 204 z1= 1 0.723532824287512E-07 0.000000000000000E+00 z1= 2 -.554142716026903E-03 0.000000000000000E+00 z1= 3 0.135765410937618E-06 0.000000000000000E+00 alpha(00000204)=0.000000000000000E+00 beta (00000205)=0.121520316964345E+02 gamma(00000205)=0.121520316964345E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 205 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000205)=0.000000000000000E+00 beta (00000206)=0.135215302752590E+02 gamma(00000206)=0.135215302752590E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 206 z1= 1 -.683339197327798E-07 0.000000000000000E+00 z1= 2 0.609040099449806E-03 0.000000000000000E+00 z1= 3 -.128699842726586E-06 0.000000000000000E+00 alpha(00000206)=0.000000000000000E+00 beta (00000207)=0.124827259742472E+02 gamma(00000207)=0.124827259742472E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 207 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000207)=0.000000000000000E+00 beta (00000208)=0.134709384012553E+02 gamma(00000208)=0.134709384012553E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 208 z1= 1 0.671226742477923E-07 0.000000000000000E+00 z1= 2 -.633385785251494E-03 0.000000000000000E+00 z1= 3 0.129019577194221E-06 0.000000000000000E+00 alpha(00000208)=0.000000000000000E+00 beta (00000209)=0.123383324233898E+02 gamma(00000209)=0.123383324233898E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 209 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000209)=0.000000000000000E+00 beta (00000210)=0.133462114457034E+02 gamma(00000210)=0.133462114457034E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 210 z1= 1 -.659334701415097E-07 0.000000000000000E+00 z1= 2 0.710380963936982E-03 0.000000000000000E+00 z1= 3 -.131127594541923E-06 0.000000000000000E+00 alpha(00000210)=0.000000000000000E+00 beta (00000211)=0.131432087567983E+02 gamma(00000211)=0.131432087567983E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 211 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000211)=0.000000000000000E+00 beta (00000212)=0.129313045027757E+02 gamma(00000212)=0.129313045027757E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 212 z1= 1 0.722339205190721E-07 0.000000000000000E+00 z1= 2 -.787573260898898E-03 0.000000000000000E+00 z1= 3 0.144579824058874E-06 0.000000000000000E+00 alpha(00000212)=0.000000000000000E+00 beta (00000213)=0.120316615835570E+02 gamma(00000213)=0.120316615835570E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 213 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000213)=0.000000000000000E+00 beta (00000214)=0.134635627869299E+02 gamma(00000214)=0.134635627869299E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 214 z1= 1 -.703531384408165E-07 0.000000000000000E+00 z1= 2 0.575173972996565E-03 0.000000000000000E+00 z1= 3 -.140562159290075E-06 0.000000000000000E+00 alpha(00000214)=0.000000000000000E+00 beta (00000215)=0.127773645292543E+02 gamma(00000215)=0.127773645292543E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 215 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000215)=0.000000000000000E+00 beta (00000216)=0.137654265551468E+02 gamma(00000216)=0.137654265551468E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 216 z1= 1 0.700999652071370E-07 0.000000000000000E+00 z1= 2 -.157571233832862E-03 0.000000000000000E+00 z1= 3 0.139105491573288E-06 0.000000000000000E+00 alpha(00000216)=0.000000000000000E+00 beta (00000217)=0.129434865834210E+02 gamma(00000217)=0.129434865834210E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 217 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000217)=0.000000000000000E+00 beta (00000218)=0.135801757979937E+02 gamma(00000218)=0.135801757979937E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 218 z1= 1 -.731419682307478E-07 0.000000000000000E+00 z1= 2 -.397894702457676E-03 0.000000000000000E+00 z1= 3 -.141085602780883E-06 0.000000000000000E+00 alpha(00000218)=0.000000000000000E+00 beta (00000219)=0.131426381191694E+02 gamma(00000219)=0.131426381191694E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 219 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000219)=0.000000000000000E+00 beta (00000220)=0.139478839045027E+02 gamma(00000220)=0.139478839045027E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 220 z1= 1 0.748709950597944E-07 0.000000000000000E+00 z1= 2 0.976272501072704E-03 0.000000000000000E+00 z1= 3 0.140611827709192E-06 0.000000000000000E+00 alpha(00000220)=0.000000000000000E+00 beta (00000221)=0.131240233338208E+02 gamma(00000221)=0.131240233338208E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 221 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000221)=0.000000000000000E+00 beta (00000222)=0.139778847414415E+02 gamma(00000222)=0.139778847414415E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 222 z1= 1 -.764074264686517E-07 0.000000000000000E+00 z1= 2 -.144066410993389E-02 0.000000000000000E+00 z1= 3 -.139028950740371E-06 0.000000000000000E+00 alpha(00000222)=0.000000000000000E+00 beta (00000223)=0.124280521902604E+02 gamma(00000223)=0.124280521902604E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 223 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000223)=0.000000000000000E+00 beta (00000224)=0.132944047955375E+02 gamma(00000224)=0.132944047955375E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 224 z1= 1 0.785197182421107E-07 0.000000000000000E+00 z1= 2 0.185286175894190E-02 0.000000000000000E+00 z1= 3 0.138895562420667E-06 0.000000000000000E+00 alpha(00000224)=0.000000000000000E+00 beta (00000225)=0.122136753751130E+02 gamma(00000225)=0.122136753751130E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 225 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000225)=0.000000000000000E+00 beta (00000226)=0.138023390026679E+02 gamma(00000226)=0.138023390026679E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 226 z1= 1 -.740978053047348E-07 0.000000000000000E+00 z1= 2 -.205755239048773E-02 0.000000000000000E+00 z1= 3 -.130510109205134E-06 0.000000000000000E+00 alpha(00000226)=0.000000000000000E+00 beta (00000227)=0.128195358679847E+02 gamma(00000227)=0.128195358679847E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 227 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000227)=0.000000000000000E+00 beta (00000228)=0.133703296793574E+02 gamma(00000228)=0.133703296793574E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 228 z1= 1 0.764920695126362E-07 0.000000000000000E+00 z1= 2 0.232578148690362E-02 0.000000000000000E+00 z1= 3 0.133699044667943E-06 0.000000000000000E+00 alpha(00000228)=0.000000000000000E+00 beta (00000229)=0.125924973576193E+02 gamma(00000229)=0.125924973576193E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 229 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000229)=0.000000000000000E+00 beta (00000230)=0.130192214587818E+02 gamma(00000230)=0.130192214587818E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 230 z1= 1 -.797211108238827E-07 0.000000000000000E+00 z1= 2 -.254073153869657E-02 0.000000000000000E+00 z1= 3 -.138345052908180E-06 0.000000000000000E+00 alpha(00000230)=0.000000000000000E+00 beta (00000231)=0.127333210725239E+02 gamma(00000231)=0.127333210725239E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 231 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000231)=0.000000000000000E+00 beta (00000232)=0.139348341850155E+02 gamma(00000232)=0.139348341850155E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 232 z1= 1 0.779774717348664E-07 0.000000000000000E+00 z1= 2 0.246908740811266E-02 0.000000000000000E+00 z1= 3 0.132950910791831E-06 0.000000000000000E+00 alpha(00000232)=0.000000000000000E+00 beta (00000233)=0.130952324601606E+02 gamma(00000233)=0.130952324601606E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 233 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000233)=0.000000000000000E+00 beta (00000234)=0.137083000581590E+02 gamma(00000234)=0.137083000581590E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 234 z1= 1 -.799435170440593E-07 0.000000000000000E+00 z1= 2 -.244724031930026E-02 0.000000000000000E+00 z1= 3 -.132685432634023E-06 0.000000000000000E+00 alpha(00000234)=0.000000000000000E+00 beta (00000235)=0.130599268252338E+02 gamma(00000235)=0.130599268252338E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 235 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000235)=0.000000000000000E+00 beta (00000236)=0.137365068474182E+02 gamma(00000236)=0.137365068474182E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 236 z1= 1 0.820895280327638E-07 0.000000000000000E+00 z1= 2 0.235351367971965E-02 0.000000000000000E+00 z1= 3 0.131868045655486E-06 0.000000000000000E+00 alpha(00000236)=0.000000000000000E+00 beta (00000237)=0.129746600953337E+02 gamma(00000237)=0.129746600953337E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 237 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000237)=0.000000000000000E+00 beta (00000238)=0.134991693104977E+02 gamma(00000238)=0.134991693104977E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 238 z1= 1 -.870959464540841E-07 0.000000000000000E+00 z1= 2 -.221080017841426E-02 0.000000000000000E+00 z1= 3 -.134094096585391E-06 0.000000000000000E+00 alpha(00000238)=0.000000000000000E+00 beta (00000239)=0.128953539969874E+02 gamma(00000239)=0.128953539969874E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 239 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000239)=0.000000000000000E+00 beta (00000240)=0.140822858962090E+02 gamma(00000240)=0.140822858962090E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 240 z1= 1 0.879580961958733E-07 0.000000000000000E+00 z1= 2 0.197406631632401E-02 0.000000000000000E+00 z1= 3 0.128796639534243E-06 0.000000000000000E+00 alpha(00000240)=0.000000000000000E+00 beta (00000241)=0.127853612161041E+02 gamma(00000241)=0.127853612161041E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 241 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000241)=0.000000000000000E+00 beta (00000242)=0.137913038408670E+02 gamma(00000242)=0.137913038408670E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 242 z1= 1 -.889495173983859E-07 0.000000000000000E+00 z1= 2 -.177466426975522E-02 0.000000000000000E+00 z1= 3 -.123823400340300E-06 0.000000000000000E+00 alpha(00000242)=0.000000000000000E+00 beta (00000243)=0.128796903786209E+02 gamma(00000243)=0.128796903786209E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 243 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000243)=0.000000000000000E+00 beta (00000244)=0.129163217565439E+02 gamma(00000244)=0.129163217565439E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 244 z1= 1 0.966338766726074E-07 0.000000000000000E+00 z1= 2 0.173033020944329E-02 0.000000000000000E+00 z1= 3 0.128681168845243E-06 0.000000000000000E+00 alpha(00000244)=0.000000000000000E+00 beta (00000245)=0.122324383398922E+02 gamma(00000245)=0.122324383398922E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 245 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000245)=0.000000000000000E+00 beta (00000246)=0.134038472372868E+02 gamma(00000246)=0.134038472372868E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 246 z1= 1 -.939736004504236E-07 0.000000000000000E+00 z1= 2 -.154101078624984E-02 0.000000000000000E+00 z1= 3 -.121009113575191E-06 0.000000000000000E+00 alpha(00000246)=0.000000000000000E+00 beta (00000247)=0.122777852802178E+02 gamma(00000247)=0.122777852802178E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 247 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000247)=0.000000000000000E+00 beta (00000248)=0.135848176724360E+02 gamma(00000248)=0.135848176724360E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 248 z1= 1 0.895124446216675E-07 0.000000000000000E+00 z1= 2 0.142000780339166E-02 0.000000000000000E+00 z1= 3 0.111578802713020E-06 0.000000000000000E+00 alpha(00000248)=0.000000000000000E+00 beta (00000249)=0.130687283160972E+02 gamma(00000249)=0.130687283160972E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 249 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000249)=0.000000000000000E+00 beta (00000250)=0.134102291081558E+02 gamma(00000250)=0.134102291081558E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 250 z1= 1 -.923522153345197E-07 0.000000000000000E+00 z1= 2 -.143104984353787E-02 0.000000000000000E+00 z1= 3 -.111867761766753E-06 0.000000000000000E+00 alpha(00000250)=0.000000000000000E+00 beta (00000251)=0.126421983061913E+02 gamma(00000251)=0.126421983061913E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 251 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000251)=0.000000000000000E+00 beta (00000252)=0.137096206849977E+02 gamma(00000252)=0.137096206849977E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 252 z1= 1 0.869854385961199E-07 0.000000000000000E+00 z1= 2 0.145224545948776E-02 0.000000000000000E+00 z1= 3 0.104025326938041E-06 0.000000000000000E+00 alpha(00000252)=0.000000000000000E+00 beta (00000253)=0.128989862745003E+02 gamma(00000253)=0.128989862745003E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 253 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000253)=0.000000000000000E+00 beta (00000254)=0.133010384974085E+02 gamma(00000254)=0.133010384974085E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 254 z1= 1 -.845175673689757E-07 0.000000000000000E+00 z1= 2 -.156837203463496E-02 0.000000000000000E+00 z1= 3 -.102000066604362E-06 0.000000000000000E+00 alpha(00000254)=0.000000000000000E+00 beta (00000255)=0.122325719346759E+02 gamma(00000255)=0.122325719346759E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 255 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000255)=0.000000000000000E+00 beta (00000256)=0.143760054709891E+02 gamma(00000256)=0.143760054709891E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 256 z1= 1 0.731249886389701E-07 0.000000000000000E+00 z1= 2 0.149818737896081E-02 0.000000000000000E+00 z1= 3 0.891076983981515E-07 0.000000000000000E+00 alpha(00000256)=0.000000000000000E+00 beta (00000257)=0.124168910227721E+02 gamma(00000257)=0.124168910227721E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 257 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000257)=0.000000000000000E+00 beta (00000258)=0.133196411578216E+02 gamma(00000258)=0.133196411578216E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 258 z1= 1 -.675690140054808E-07 0.000000000000000E+00 z1= 2 -.168684108362313E-02 0.000000000000000E+00 z1= 3 -.836207725209582E-07 0.000000000000000E+00 alpha(00000258)=0.000000000000000E+00 beta (00000259)=0.127162333643330E+02 gamma(00000259)=0.127162333643330E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 259 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000259)=0.000000000000000E+00 beta (00000260)=0.136365134962907E+02 gamma(00000260)=0.136365134962907E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 260 z1= 1 0.614045466496363E-07 0.000000000000000E+00 z1= 2 0.192724154383436E-02 0.000000000000000E+00 z1= 3 0.797754029709411E-07 0.000000000000000E+00 alpha(00000260)=0.000000000000000E+00 beta (00000261)=0.125281254460943E+02 gamma(00000261)=0.125281254460943E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 261 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000261)=0.000000000000000E+00 beta (00000262)=0.137293766819710E+02 gamma(00000262)=0.137293766819710E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 262 z1= 1 -.545339731523528E-07 0.000000000000000E+00 z1= 2 -.213381832141327E-02 0.000000000000000E+00 z1= 3 -.743682995546719E-07 0.000000000000000E+00 alpha(00000262)=0.000000000000000E+00 beta (00000263)=0.128310537442869E+02 gamma(00000263)=0.128310537442869E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 263 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000263)=0.000000000000000E+00 beta (00000264)=0.133327078933314E+02 gamma(00000264)=0.133327078933314E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 264 z1= 1 0.523742810371042E-07 0.000000000000000E+00 z1= 2 0.233275021840413E-02 0.000000000000000E+00 z1= 3 0.721608820565328E-07 0.000000000000000E+00 alpha(00000264)=0.000000000000000E+00 beta (00000265)=0.131090107283996E+02 gamma(00000265)=0.131090107283996E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 265 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000265)=0.000000000000000E+00 beta (00000266)=0.135958565669023E+02 gamma(00000266)=0.135958565669023E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 266 z1= 1 -.502437220249036E-07 0.000000000000000E+00 z1= 2 -.240894694916041E-02 0.000000000000000E+00 z1= 3 -.712168842430748E-07 0.000000000000000E+00 alpha(00000266)=0.000000000000000E+00 beta (00000267)=0.129880412058474E+02 gamma(00000267)=0.129880412058474E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 267 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000267)=0.000000000000000E+00 beta (00000268)=0.133629508849352E+02 gamma(00000268)=0.133629508849352E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 268 z1= 1 0.479766879089155E-07 0.000000000000000E+00 z1= 2 0.257426423517875E-02 0.000000000000000E+00 z1= 3 0.701613630006974E-07 0.000000000000000E+00 alpha(00000268)=0.000000000000000E+00 beta (00000269)=0.121759125049976E+02 gamma(00000269)=0.121759125049976E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 269 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000269)=0.000000000000000E+00 beta (00000270)=0.135466217122050E+02 gamma(00000270)=0.135466217122050E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 270 z1= 1 -.430014017059263E-07 0.000000000000000E+00 z1= 2 -.255264463908681E-02 0.000000000000000E+00 z1= 3 -.650558942066827E-07 0.000000000000000E+00 alpha(00000270)=0.000000000000000E+00 beta (00000271)=0.125732336773530E+02 gamma(00000271)=0.125732336773530E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 271 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000271)=0.000000000000000E+00 beta (00000272)=0.138866546359451E+02 gamma(00000272)=0.138866546359451E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 272 z1= 1 0.404699251575769E-07 0.000000000000000E+00 z1= 2 0.249897154251701E-02 0.000000000000000E+00 z1= 3 0.615471176326505E-07 0.000000000000000E+00 alpha(00000272)=0.000000000000000E+00 beta (00000273)=0.127527349360035E+02 gamma(00000273)=0.127527349360035E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 273 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000273)=0.000000000000000E+00 beta (00000274)=0.137255322220108E+02 gamma(00000274)=0.137255322220108E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 274 z1= 1 -.401823002120147E-07 0.000000000000000E+00 z1= 2 -.243686345394249E-02 0.000000000000000E+00 z1= 3 -.588421747908883E-07 0.000000000000000E+00 alpha(00000274)=0.000000000000000E+00 beta (00000275)=0.130992330525728E+02 gamma(00000275)=0.130992330525728E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 275 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000275)=0.000000000000000E+00 beta (00000276)=0.133642782263138E+02 gamma(00000276)=0.133642782263138E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 276 z1= 1 0.423391174151494E-07 0.000000000000000E+00 z1= 2 0.253196248340050E-02 0.000000000000000E+00 z1= 3 0.606113489952408E-07 0.000000000000000E+00 alpha(00000276)=0.000000000000000E+00 beta (00000277)=0.121173623260923E+02 gamma(00000277)=0.121173623260923E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 277 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000277)=0.000000000000000E+00 beta (00000278)=0.139902136316870E+02 gamma(00000278)=0.139902136316870E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 278 z1= 1 -.401949603046070E-07 0.000000000000000E+00 z1= 2 -.234373906922644E-02 0.000000000000000E+00 z1= 3 -.577711480660606E-07 0.000000000000000E+00 alpha(00000278)=0.000000000000000E+00 beta (00000279)=0.128103165088618E+02 gamma(00000279)=0.128103165088618E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 279 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000279)=0.000000000000000E+00 beta (00000280)=0.132105565271879E+02 gamma(00000280)=0.132105565271879E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 280 z1= 1 0.433634827837204E-07 0.000000000000000E+00 z1= 2 0.242951337035524E-02 0.000000000000000E+00 z1= 3 0.610828214724296E-07 0.000000000000000E+00 alpha(00000280)=0.000000000000000E+00 beta (00000281)=0.125789341577504E+02 gamma(00000281)=0.125789341577504E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 281 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000281)=0.000000000000000E+00 beta (00000282)=0.131349772375010E+02 gamma(00000282)=0.131349772375010E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 282 z1= 1 -.450431558015815E-07 0.000000000000000E+00 z1= 2 -.246824641526658E-02 0.000000000000000E+00 z1= 3 -.633500143317704E-07 0.000000000000000E+00 alpha(00000282)=0.000000000000000E+00 beta (00000283)=0.131792312523135E+02 gamma(00000283)=0.131792312523135E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 283 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000283)=0.000000000000000E+00 beta (00000284)=0.143606108863978E+02 gamma(00000284)=0.143606108863978E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 284 z1= 1 0.458706024110758E-07 0.000000000000000E+00 z1= 2 0.240361462007349E-02 0.000000000000000E+00 z1= 3 0.617290681535982E-07 0.000000000000000E+00 alpha(00000284)=0.000000000000000E+00 beta (00000285)=0.126008194225678E+02 gamma(00000285)=0.126008194225678E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 285 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000285)=0.000000000000000E+00 beta (00000286)=0.132861051410337E+02 gamma(00000286)=0.132861051410337E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 286 z1= 1 -.486639711791415E-07 0.000000000000000E+00 z1= 2 -.242915771104654E-02 0.000000000000000E+00 z1= 3 -.614791494077437E-07 0.000000000000000E+00 alpha(00000286)=0.000000000000000E+00 beta (00000287)=0.120640557101501E+02 gamma(00000287)=0.120640557101501E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 287 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000287)=0.000000000000000E+00 beta (00000288)=0.138125218667923E+02 gamma(00000288)=0.138125218667923E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 288 z1= 1 0.474271854905214E-07 0.000000000000000E+00 z1= 2 0.233248194561575E-02 0.000000000000000E+00 z1= 3 0.579350012825915E-07 0.000000000000000E+00 alpha(00000288)=0.000000000000000E+00 beta (00000289)=0.129650142801503E+02 gamma(00000289)=0.129650142801503E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 289 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000289)=0.000000000000000E+00 beta (00000290)=0.130427903964803E+02 gamma(00000290)=0.130427903964803E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 290 z1= 1 -.533872835817989E-07 0.000000000000000E+00 z1= 2 -.246436890390398E-02 0.000000000000000E+00 z1= 3 -.631253749109359E-07 0.000000000000000E+00 alpha(00000290)=0.000000000000000E+00 beta (00000291)=0.125820257132565E+02 gamma(00000291)=0.125820257132565E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 291 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000291)=0.000000000000000E+00 beta (00000292)=0.143052311982078E+02 gamma(00000292)=0.143052311982078E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 292 z1= 1 0.526389218064721E-07 0.000000000000000E+00 z1= 2 0.226393510940813E-02 0.000000000000000E+00 z1= 3 0.595417302301808E-07 0.000000000000000E+00 alpha(00000292)=0.000000000000000E+00 beta (00000293)=0.125509345233414E+02 gamma(00000293)=0.125509345233414E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 293 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000293)=0.000000000000000E+00 beta (00000294)=0.129606210741618E+02 gamma(00000294)=0.129606210741618E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 294 z1= 1 -.565203100164405E-07 0.000000000000000E+00 z1= 2 -.220781186558579E-02 0.000000000000000E+00 z1= 3 -.619349822608288E-07 0.000000000000000E+00 alpha(00000294)=0.000000000000000E+00 beta (00000295)=0.125940438133384E+02 gamma(00000295)=0.125940438133384E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 295 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000295)=0.000000000000000E+00 beta (00000296)=0.131295939395346E+02 gamma(00000296)=0.131295939395346E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 296 z1= 1 0.570292382276461E-07 0.000000000000000E+00 z1= 2 0.214133404115059E-02 0.000000000000000E+00 z1= 3 0.631466408785469E-07 0.000000000000000E+00 alpha(00000296)=0.000000000000000E+00 beta (00000297)=0.129634003576116E+02 gamma(00000297)=0.129634003576116E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 297 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000297)=0.000000000000000E+00 beta (00000298)=0.139119448823634E+02 gamma(00000298)=0.139119448823634E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 298 z1= 1 -.549743308085084E-07 0.000000000000000E+00 z1= 2 -.209152188958125E-02 0.000000000000000E+00 z1= 3 -.621552280593565E-07 0.000000000000000E+00 alpha(00000298)=0.000000000000000E+00 beta (00000299)=0.122074064924069E+02 gamma(00000299)=0.122074064924069E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 299 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000299)=0.000000000000000E+00 beta (00000300)=0.141326889005375E+02 gamma(00000300)=0.141326889005375E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 300 z1= 1 0.482917106353533E-07 0.000000000000000E+00 z1= 2 0.201363753775203E-02 0.000000000000000E+00 z1= 3 0.557059078219952E-07 0.000000000000000E+00 alpha(00000300)=0.000000000000000E+00 beta (00000301)=0.124081187539380E+02 gamma(00000301)=0.124081187539380E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 301 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000301)=0.000000000000000E+00 beta (00000302)=0.132797888109620E+02 gamma(00000302)=0.132797888109620E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 302 z1= 1 -.465792825486526E-07 0.000000000000000E+00 z1= 2 -.206817457179488E-02 0.000000000000000E+00 z1= 3 -.530667027643728E-07 0.000000000000000E+00 alpha(00000302)=0.000000000000000E+00 beta (00000303)=0.123578266579880E+02 gamma(00000303)=0.123578266579880E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 303 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000303)=0.000000000000000E+00 beta (00000304)=0.140295841044203E+02 gamma(00000304)=0.140295841044203E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 304 z1= 1 0.441485535785519E-07 0.000000000000000E+00 z1= 2 0.189097754571742E-02 0.000000000000000E+00 z1= 3 0.481075181712294E-07 0.000000000000000E+00 alpha(00000304)=0.000000000000000E+00 beta (00000305)=0.127961088219574E+02 gamma(00000305)=0.127961088219574E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 305 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000305)=0.000000000000000E+00 beta (00000306)=0.137977725531049E+02 gamma(00000306)=0.137977725531049E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 306 z1= 1 -.431642824070405E-07 0.000000000000000E+00 z1= 2 -.183340730234857E-02 0.000000000000000E+00 z1= 3 -.462942695517252E-07 0.000000000000000E+00 alpha(00000306)=0.000000000000000E+00 beta (00000307)=0.131450890617241E+02 gamma(00000307)=0.131450890617241E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 307 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000307)=0.000000000000000E+00 beta (00000308)=0.136604629135665E+02 gamma(00000308)=0.136604629135665E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 308 z1= 1 0.402939530652104E-07 0.000000000000000E+00 z1= 2 0.183646351017546E-02 0.000000000000000E+00 z1= 3 0.457837996398333E-07 0.000000000000000E+00 alpha(00000308)=0.000000000000000E+00 beta (00000309)=0.133370453381972E+02 gamma(00000309)=0.133370453381972E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 309 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000309)=0.000000000000000E+00 beta (00000310)=0.134489506393781E+02 gamma(00000310)=0.134489506393781E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 310 z1= 1 -.381610028438173E-07 0.000000000000000E+00 z1= 2 -.184654937715266E-02 0.000000000000000E+00 z1= 3 -.452900693972166E-07 0.000000000000000E+00 alpha(00000310)=0.000000000000000E+00 beta (00000311)=0.126213887567218E+02 gamma(00000311)=0.126213887567218E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 311 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000311)=0.000000000000000E+00 beta (00000312)=0.132135846893529E+02 gamma(00000312)=0.132135846893529E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 312 z1= 1 0.346718491165895E-07 0.000000000000000E+00 z1= 2 0.169546218149426E-02 0.000000000000000E+00 z1= 3 0.417865103299225E-07 0.000000000000000E+00 alpha(00000312)=0.000000000000000E+00 beta (00000313)=0.121896328507108E+02 gamma(00000313)=0.121896328507108E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 313 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000313)=0.000000000000000E+00 beta (00000314)=0.134874669702945E+02 gamma(00000314)=0.134874669702945E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 314 z1= 1 -.336443361347721E-07 0.000000000000000E+00 z1= 2 -.137810050224018E-02 0.000000000000000E+00 z1= 3 -.383302104533297E-07 0.000000000000000E+00 alpha(00000314)=0.000000000000000E+00 beta (00000315)=0.126276862627802E+02 gamma(00000315)=0.126276862627802E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 315 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000315)=0.000000000000000E+00 beta (00000316)=0.136908999535475E+02 gamma(00000316)=0.136908999535475E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 316 z1= 1 0.317508854590087E-07 0.000000000000000E+00 z1= 2 0.100833459790124E-02 0.000000000000000E+00 z1= 3 0.347768808712048E-07 0.000000000000000E+00 alpha(00000316)=0.000000000000000E+00 beta (00000317)=0.117011396442113E+02 gamma(00000317)=0.117011396442113E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 317 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000317)=0.000000000000000E+00 beta (00000318)=0.139180584235020E+02 gamma(00000318)=0.139180584235020E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 318 z1= 1 -.269448946705123E-07 0.000000000000000E+00 z1= 2 -.434651759565037E-03 0.000000000000000E+00 z1= 3 -.268866824495800E-07 0.000000000000000E+00 alpha(00000318)=0.000000000000000E+00 beta (00000319)=0.131626553856937E+02 gamma(00000319)=0.131626553856937E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 319 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000319)=0.000000000000000E+00 beta (00000320)=0.140978832880459E+02 gamma(00000320)=0.140978832880459E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 320 z1= 1 0.229847601702395E-07 0.000000000000000E+00 z1= 2 0.330003334142234E-04 0.000000000000000E+00 z1= 3 0.228798503309601E-07 0.000000000000000E+00 alpha(00000320)=0.000000000000000E+00 beta (00000321)=0.120706028412897E+02 gamma(00000321)=0.120706028412897E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 321 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000321)=0.000000000000000E+00 beta (00000322)=0.138363872786849E+02 gamma(00000322)=0.138363872786849E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 322 z1= 1 -.183979141136180E-07 0.000000000000000E+00 z1= 2 0.331336347523917E-03 0.000000000000000E+00 z1= 3 -.199644243645074E-07 0.000000000000000E+00 alpha(00000322)=0.000000000000000E+00 beta (00000323)=0.123117798531131E+02 gamma(00000323)=0.123117798531131E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 323 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000323)=0.000000000000000E+00 beta (00000324)=0.143021767787011E+02 gamma(00000324)=0.143021767787011E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 324 z1= 1 0.133448668396090E-07 0.000000000000000E+00 z1= 2 -.516067919075505E-03 0.000000000000000E+00 z1= 3 0.177781215996212E-07 0.000000000000000E+00 alpha(00000324)=0.000000000000000E+00 beta (00000325)=0.132557113449471E+02 gamma(00000325)=0.132557113449471E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 325 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000325)=0.000000000000000E+00 beta (00000326)=0.143085335941069E+02 gamma(00000326)=0.143085335941069E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 326 z1= 1 -.108059640537917E-07 0.000000000000000E+00 z1= 2 0.536941076419225E-03 0.000000000000000E+00 z1= 3 -.182565436106133E-07 0.000000000000000E+00 alpha(00000326)=0.000000000000000E+00 beta (00000327)=0.127036891458789E+02 gamma(00000327)=0.127036891458789E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 327 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000327)=0.000000000000000E+00 beta (00000328)=0.133137706132571E+02 gamma(00000328)=0.133137706132571E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 328 z1= 1 0.458400216358590E-08 0.000000000000000E+00 z1= 2 -.429048415634191E-03 0.000000000000000E+00 z1= 3 0.169711721399214E-07 0.000000000000000E+00 alpha(00000328)=0.000000000000000E+00 beta (00000329)=0.131560817986884E+02 gamma(00000329)=0.131560817986884E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 329 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000329)=0.000000000000000E+00 beta (00000330)=0.140851243145985E+02 gamma(00000330)=0.140851243145985E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 330 z1= 1 -.162947505315258E-09 0.000000000000000E+00 z1= 2 0.285959530340722E-03 0.000000000000000E+00 z1= 3 -.147077164114925E-07 0.000000000000000E+00 alpha(00000330)=0.000000000000000E+00 beta (00000331)=0.122001434018207E+02 gamma(00000331)=0.122001434018207E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 331 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000331)=0.000000000000000E+00 beta (00000332)=0.138682195826723E+02 gamma(00000332)=0.138682195826723E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 332 z1= 1 -.250573930224776E-08 0.000000000000000E+00 z1= 2 -.158581965208108E-03 0.000000000000000E+00 z1= 3 0.129562169806635E-07 0.000000000000000E+00 alpha(00000332)=0.000000000000000E+00 beta (00000333)=0.124681582733158E+02 gamma(00000333)=0.124681582733158E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 333 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000333)=0.000000000000000E+00 beta (00000334)=0.130822660952032E+02 gamma(00000334)=0.130822660952032E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 334 z1= 1 0.290969478329225E-08 0.000000000000000E+00 z1= 2 0.835010036602463E-04 0.000000000000000E+00 z1= 3 -.123157462604220E-07 0.000000000000000E+00 alpha(00000334)=0.000000000000000E+00 beta (00000335)=0.128934191687481E+02 gamma(00000335)=0.128934191687481E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 335 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000335)=0.000000000000000E+00 beta (00000336)=0.129414924346988E+02 gamma(00000336)=0.129414924346988E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 336 z1= 1 -.452234424474368E-08 0.000000000000000E+00 z1= 2 -.120391632130810E-03 0.000000000000000E+00 z1= 3 0.120393887490704E-07 0.000000000000000E+00 alpha(00000336)=0.000000000000000E+00 beta (00000337)=0.127486010725625E+02 gamma(00000337)=0.127486010725625E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 337 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000337)=0.000000000000000E+00 beta (00000338)=0.125341359851369E+02 gamma(00000338)=0.125341359851369E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 338 z1= 1 0.811883511114830E-08 0.000000000000000E+00 z1= 2 0.249381723162545E-03 0.000000000000000E+00 z1= 3 -.132923907657348E-07 0.000000000000000E+00 alpha(00000338)=0.000000000000000E+00 beta (00000339)=0.139103124500425E+02 gamma(00000339)=0.139103124500425E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 339 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000339)=0.000000000000000E+00 beta (00000340)=0.135512423748187E+02 gamma(00000340)=0.135512423748187E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 340 z1= 1 -.102518927817472E-07 0.000000000000000E+00 z1= 2 -.386148967059865E-03 0.000000000000000E+00 z1= 3 0.141014670613192E-07 0.000000000000000E+00 alpha(00000340)=0.000000000000000E+00 beta (00000341)=0.122830025258551E+02 gamma(00000341)=0.122830025258551E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 341 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000341)=0.000000000000000E+00 beta (00000342)=0.139611936666345E+02 gamma(00000342)=0.139611936666345E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 342 z1= 1 0.125204146148028E-07 0.000000000000000E+00 z1= 2 0.549312948527220E-03 0.000000000000000E+00 z1= 3 -.115668783208742E-07 0.000000000000000E+00 alpha(00000342)=0.000000000000000E+00 beta (00000343)=0.127250597737427E+02 gamma(00000343)=0.127250597737427E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 343 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000343)=0.000000000000000E+00 beta (00000344)=0.137578372739201E+02 gamma(00000344)=0.137578372739201E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 344 z1= 1 -.138270692053195E-07 0.000000000000000E+00 z1= 2 -.782072063472345E-03 0.000000000000000E+00 z1= 3 0.106751634537348E-07 0.000000000000000E+00 alpha(00000344)=0.000000000000000E+00 beta (00000345)=0.123649711106971E+02 gamma(00000345)=0.123649711106971E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 345 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000345)=0.000000000000000E+00 beta (00000346)=0.142151255596789E+02 gamma(00000346)=0.142151255596789E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 346 z1= 1 0.155187868354500E-07 0.000000000000000E+00 z1= 2 0.909074023585542E-03 0.000000000000000E+00 z1= 3 -.959675310947843E-08 0.000000000000000E+00 alpha(00000346)=0.000000000000000E+00 beta (00000347)=0.124959013565733E+02 gamma(00000347)=0.124959013565733E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 347 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000347)=0.000000000000000E+00 beta (00000348)=0.146128371827278E+02 gamma(00000348)=0.146128371827278E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 348 z1= 1 -.144799716626787E-07 0.000000000000000E+00 z1= 2 -.107328985732823E-02 0.000000000000000E+00 z1= 3 0.948061861899248E-08 0.000000000000000E+00 alpha(00000348)=0.000000000000000E+00 beta (00000349)=0.121775288542880E+02 gamma(00000349)=0.121775288542880E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 349 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000349)=0.000000000000000E+00 beta (00000350)=0.129210675017439E+02 gamma(00000350)=0.129210675017439E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 350 z1= 1 0.218167672291596E-07 0.000000000000000E+00 z1= 2 0.137532051385213E-02 0.000000000000000E+00 z1= 3 -.500610526429500E-08 0.000000000000000E+00 alpha(00000350)=0.000000000000000E+00 beta (00000351)=0.128674321851826E+02 gamma(00000351)=0.128674321851826E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 351 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000351)=0.000000000000000E+00 beta (00000352)=0.140458832293554E+02 gamma(00000352)=0.140458832293554E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 352 z1= 1 -.236131861134671E-07 0.000000000000000E+00 z1= 2 -.146319413940976E-02 0.000000000000000E+00 z1= 3 0.361283753938903E-08 0.000000000000000E+00 alpha(00000352)=0.000000000000000E+00 beta (00000353)=0.125007338747368E+02 gamma(00000353)=0.125007338747368E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 353 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000353)=0.000000000000000E+00 beta (00000354)=0.134584457428844E+02 gamma(00000354)=0.134584457428844E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 354 z1= 1 0.323926691585437E-07 0.000000000000000E+00 z1= 2 0.147927677435623E-02 0.000000000000000E+00 z1= 3 0.262021428892086E-08 0.000000000000000E+00 alpha(00000354)=0.000000000000000E+00 beta (00000355)=0.125146017650973E+02 gamma(00000355)=0.125146017650973E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 355 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000355)=0.000000000000000E+00 beta (00000356)=0.133938363754901E+02 gamma(00000356)=0.133938363754901E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 356 z1= 1 -.371536708016016E-07 0.000000000000000E+00 z1= 2 -.146106076088833E-02 0.000000000000000E+00 z1= 3 -.504562338839252E-08 0.000000000000000E+00 alpha(00000356)=0.000000000000000E+00 beta (00000357)=0.123724280815124E+02 gamma(00000357)=0.123724280815124E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 357 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000357)=0.000000000000000E+00 beta (00000358)=0.137873533812791E+02 gamma(00000358)=0.137873533812791E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 358 z1= 1 0.485486332153524E-07 0.000000000000000E+00 z1= 2 0.124278272615006E-02 0.000000000000000E+00 z1= 3 0.986080201639730E-08 0.000000000000000E+00 alpha(00000358)=0.000000000000000E+00 beta (00000359)=0.125468362404570E+02 gamma(00000359)=0.125468362404570E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 359 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000359)=0.000000000000000E+00 beta (00000360)=0.137236787907175E+02 gamma(00000360)=0.137236787907175E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 360 z1= 1 -.524329876322449E-07 0.000000000000000E+00 z1= 2 -.880776045815716E-03 0.000000000000000E+00 z1= 3 -.114339511830494E-07 0.000000000000000E+00 alpha(00000360)=0.000000000000000E+00 beta (00000361)=0.124990745115606E+02 gamma(00000361)=0.124990745115606E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 361 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000361)=0.000000000000000E+00 beta (00000362)=0.132496074404243E+02 gamma(00000362)=0.132496074404243E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 362 z1= 1 0.709538491155959E-07 0.000000000000000E+00 z1= 2 0.402900132875626E-03 0.000000000000000E+00 z1= 3 0.214274483560401E-07 0.000000000000000E+00 alpha(00000362)=0.000000000000000E+00 beta (00000363)=0.127067810371204E+02 gamma(00000363)=0.127067810371204E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 363 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000363)=0.000000000000000E+00 beta (00000364)=0.139578656971458E+02 gamma(00000364)=0.139578656971458E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 364 z1= 1 -.700447459274674E-07 0.000000000000000E+00 z1= 2 0.210755448828875E-03 0.000000000000000E+00 z1= 3 -.204400662517392E-07 0.000000000000000E+00 alpha(00000364)=0.000000000000000E+00 beta (00000365)=0.130238787556429E+02 gamma(00000365)=0.130238787556429E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 365 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000365)=0.000000000000000E+00 beta (00000366)=0.131037643470366E+02 gamma(00000366)=0.131037643470366E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 366 z1= 1 0.962877304958899E-07 0.000000000000000E+00 z1= 2 -.751935381669188E-03 0.000000000000000E+00 z1= 3 0.342470426525497E-07 0.000000000000000E+00 alpha(00000366)=0.000000000000000E+00 beta (00000367)=0.127855291077420E+02 gamma(00000367)=0.127855291077420E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 367 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000367)=0.000000000000000E+00 beta (00000368)=0.130550582633888E+02 gamma(00000368)=0.130550582633888E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 368 z1= 1 -.944014303087696E-07 0.000000000000000E+00 z1= 2 0.119985411052279E-02 0.000000000000000E+00 z1= 3 -.316199414486539E-07 0.000000000000000E+00 alpha(00000368)=0.000000000000000E+00 beta (00000369)=0.124410469328901E+02 gamma(00000369)=0.124410469328901E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 369 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000369)=0.000000000000000E+00 beta (00000370)=0.138354075941345E+02 gamma(00000370)=0.138354075941345E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 370 z1= 1 0.118366157268257E-06 0.000000000000000E+00 z1= 2 -.146556829481604E-02 0.000000000000000E+00 z1= 3 0.476341563079049E-07 0.000000000000000E+00 alpha(00000370)=0.000000000000000E+00 beta (00000371)=0.124632705058442E+02 gamma(00000371)=0.124632705058442E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 371 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000371)=0.000000000000000E+00 beta (00000372)=0.136403289735926E+02 gamma(00000372)=0.136403289735926E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 372 z1= 1 -.900848750669432E-07 0.000000000000000E+00 z1= 2 0.165029554811298E-02 0.000000000000000E+00 z1= 3 -.322080562415220E-07 0.000000000000000E+00 alpha(00000372)=0.000000000000000E+00 beta (00000373)=0.126352909669875E+02 gamma(00000373)=0.126352909669875E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 373 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000373)=0.000000000000000E+00 beta (00000374)=0.138198018621994E+02 gamma(00000374)=0.138198018621994E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 374 z1= 1 0.129506955858991E-06 0.000000000000000E+00 z1= 2 -.190596628865131E-02 0.000000000000000E+00 z1= 3 0.584597706660295E-07 0.000000000000000E+00 alpha(00000374)=0.000000000000000E+00 beta (00000375)=0.133412084209667E+02 gamma(00000375)=0.133412084209667E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 375 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000375)=0.000000000000000E+00 beta (00000376)=0.137204819761533E+02 gamma(00000376)=0.137204819761533E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 376 z1= 1 -.911851137947589E-07 0.000000000000000E+00 z1= 2 0.222391870957127E-02 0.000000000000000E+00 z1= 3 -.361949751607159E-07 0.000000000000000E+00 alpha(00000376)=0.000000000000000E+00 beta (00000377)=0.124932006309632E+02 gamma(00000377)=0.124932006309632E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 377 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000377)=0.000000000000000E+00 beta (00000378)=0.140809903386272E+02 gamma(00000378)=0.140809903386272E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 378 z1= 1 0.132480459910916E-06 0.000000000000000E+00 z1= 2 -.215284548489577E-02 0.000000000000000E+00 z1= 3 0.630822809869988E-07 0.000000000000000E+00 alpha(00000378)=0.000000000000000E+00 beta (00000379)=0.123110907161553E+02 gamma(00000379)=0.123110907161553E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 379 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000379)=0.000000000000000E+00 beta (00000380)=0.131979531417571E+02 gamma(00000380)=0.131979531417571E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 380 z1= 1 -.833333733370797E-07 0.000000000000000E+00 z1= 2 0.202213278400451E-02 0.000000000000000E+00 z1= 3 -.312474507654448E-07 0.000000000000000E+00 alpha(00000380)=0.000000000000000E+00 beta (00000381)=0.127187497329194E+02 gamma(00000381)=0.127187497329194E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 381 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000381)=0.000000000000000E+00 beta (00000382)=0.136000856349288E+02 gamma(00000382)=0.136000856349288E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 382 z1= 1 0.143454211778298E-06 0.000000000000000E+00 z1= 2 -.166965500602626E-02 0.000000000000000E+00 z1= 3 0.646994010966399E-07 0.000000000000000E+00 alpha(00000382)=0.000000000000000E+00 beta (00000383)=0.136979090975943E+02 gamma(00000383)=0.136979090975943E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 383 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000383)=0.000000000000000E+00 beta (00000384)=0.129582475973253E+02 gamma(00000384)=0.129582475973253E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 384 z1= 1 -.891330616901304E-07 0.000000000000000E+00 z1= 2 0.145771137433496E-02 0.000000000000000E+00 z1= 3 -.261635598031553E-07 0.000000000000000E+00 alpha(00000384)=0.000000000000000E+00 beta (00000385)=0.122814547244936E+02 gamma(00000385)=0.122814547244936E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 385 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000385)=0.000000000000000E+00 beta (00000386)=0.143191687203567E+02 gamma(00000386)=0.143191687203567E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 386 z1= 1 0.155492589720588E-06 0.000000000000000E+00 z1= 2 -.105943811431336E-02 0.000000000000000E+00 z1= 3 0.652828492578978E-07 0.000000000000000E+00 alpha(00000386)=0.000000000000000E+00 beta (00000387)=0.122998539252391E+02 gamma(00000387)=0.122998539252391E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 387 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000387)=0.000000000000000E+00 beta (00000388)=0.138137229670109E+02 gamma(00000388)=0.138137229670109E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 388 z1= 1 -.611679390760417E-07 0.000000000000000E+00 z1= 2 0.812075481675924E-03 0.000000000000000E+00 z1= 3 -.717743540420762E-08 0.000000000000000E+00 alpha(00000388)=0.000000000000000E+00 beta (00000389)=0.130554323855124E+02 gamma(00000389)=0.130554323855124E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 389 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000389)=0.000000000000000E+00 beta (00000390)=0.133484505143821E+02 gamma(00000390)=0.133484505143821E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 390 z1= 1 0.166636589291492E-06 0.000000000000000E+00 z1= 2 -.724814381502997E-03 0.000000000000000E+00 z1= 3 0.684650736362184E-07 0.000000000000000E+00 alpha(00000390)=0.000000000000000E+00 beta (00000391)=0.129140859220307E+02 gamma(00000391)=0.129140859220307E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 391 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000391)=0.000000000000000E+00 beta (00000392)=0.131157351492026E+02 gamma(00000392)=0.131157351492026E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 392 z1= 1 -.585456321356564E-07 0.000000000000000E+00 z1= 2 0.722822543755202E-03 0.000000000000000E+00 z1= 3 -.691133195975229E-09 0.000000000000000E+00 alpha(00000392)=0.000000000000000E+00 beta (00000393)=0.131957439554234E+02 gamma(00000393)=0.131957439554234E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 393 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000393)=0.000000000000000E+00 beta (00000394)=0.135932733091984E+02 gamma(00000394)=0.135932733091984E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 394 z1= 1 0.190641644696749E-06 0.000000000000000E+00 z1= 2 -.720822598320531E-03 0.000000000000000E+00 z1= 3 0.779715606311201E-07 0.000000000000000E+00 alpha(00000394)=0.000000000000000E+00 beta (00000395)=0.119995570881139E+02 gamma(00000395)=0.119995570881139E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 395 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000395)=0.000000000000000E+00 beta (00000396)=0.140192553316307E+02 gamma(00000396)=0.140192553316307E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 396 z1= 1 -.223763812581042E-07 0.000000000000000E+00 z1= 2 0.531417498530629E-03 0.000000000000000E+00 z1= 3 0.195145092664372E-07 0.000000000000000E+00 alpha(00000396)=0.000000000000000E+00 beta (00000397)=0.132179700920902E+02 gamma(00000397)=0.132179700920902E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 397 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000397)=0.000000000000000E+00 beta (00000398)=0.143631174280688E+02 gamma(00000398)=0.143631174280688E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 398 z1= 1 0.188118009800857E-06 0.000000000000000E+00 z1= 2 -.308240607535063E-03 0.000000000000000E+00 z1= 3 0.799345189495264E-07 0.000000000000000E+00 alpha(00000398)=0.000000000000000E+00 beta (00000399)=0.120770941594637E+02 gamma(00000399)=0.120770941594637E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 399 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000399)=0.000000000000000E+00 beta (00000400)=0.133450825050691E+02 gamma(00000400)=0.133450825050691E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 400 z1= 1 -.299710486116600E-08 0.000000000000000E+00 z1= 2 0.310040563193132E-04 0.000000000000000E+00 z1= 3 0.310768641151164E-07 0.000000000000000E+00 alpha(00000400)=0.000000000000000E+00 beta (00000401)=0.129315006807382E+02 gamma(00000401)=0.129315006807382E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 401 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000401)=0.000000000000000E+00 beta (00000402)=0.132737794996892E+02 gamma(00000402)=0.132737794996892E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 402 z1= 1 0.187554234464980E-06 0.000000000000000E+00 z1= 2 0.839043849479512E-04 0.000000000000000E+00 z1= 3 0.763877926989169E-07 0.000000000000000E+00 alpha(00000402)=0.000000000000000E+00 beta (00000403)=0.128659222659429E+02 gamma(00000403)=0.128659222659429E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 403 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000403)=0.000000000000000E+00 beta (00000404)=0.137931123194293E+02 gamma(00000404)=0.137931123194293E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 404 z1= 1 0.234924051982499E-07 0.000000000000000E+00 z1= 2 -.138366066880440E-03 0.000000000000000E+00 z1= 3 0.483336735077121E-07 0.000000000000000E+00 alpha(00000404)=0.000000000000000E+00 beta (00000405)=0.134439764107074E+02 gamma(00000405)=0.134439764107074E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 405 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000405)=0.000000000000000E+00 beta (00000406)=0.135932117445147E+02 gamma(00000406)=0.135932117445147E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 406 z1= 1 0.195222229478886E-06 0.000000000000000E+00 z1= 2 0.214810929287280E-03 0.000000000000000E+00 z1= 3 0.788827997909053E-07 0.000000000000000E+00 alpha(00000406)=0.000000000000000E+00 beta (00000407)=0.131824363881384E+02 gamma(00000407)=0.131824363881384E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 407 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000407)=0.000000000000000E+00 beta (00000408)=0.141173653261090E+02 gamma(00000408)=0.141173653261090E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 408 z1= 1 -.577418830371296E-08 0.000000000000000E+00 z1= 2 -.254692083813918E-03 0.000000000000000E+00 z1= 3 0.324582720971796E-07 0.000000000000000E+00 alpha(00000408)=0.000000000000000E+00 beta (00000409)=0.129395838639024E+02 gamma(00000409)=0.129395838639024E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 409 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000409)=0.000000000000000E+00 beta (00000410)=0.127534931126522E+02 gamma(00000410)=0.127534931126522E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 410 z1= 1 0.142619666228770E-06 0.000000000000000E+00 z1= 2 0.319850151000802E-03 0.000000000000000E+00 z1= 3 0.447820520064752E-07 0.000000000000000E+00 alpha(00000410)=0.000000000000000E+00 beta (00000411)=0.129534538878013E+02 gamma(00000411)=0.129534538878013E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 411 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000411)=0.000000000000000E+00 beta (00000412)=0.139247925198957E+02 gamma(00000412)=0.139247925198957E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 412 z1= 1 -.727726444428329E-07 0.000000000000000E+00 z1= 2 -.324294324704884E-03 0.000000000000000E+00 z1= 3 -.621914420138804E-08 0.000000000000000E+00 alpha(00000412)=0.000000000000000E+00 beta (00000413)=0.123737679866984E+02 gamma(00000413)=0.123737679866984E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 413 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000413)=0.000000000000000E+00 beta (00000414)=0.137567633678008E+02 gamma(00000414)=0.137567633678008E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 414 z1= 1 0.859945632017975E-07 0.000000000000000E+00 z1= 2 0.274648379879951E-03 0.000000000000000E+00 z1= 3 0.138242089061909E-07 0.000000000000000E+00 alpha(00000414)=0.000000000000000E+00 beta (00000415)=0.129608672976453E+02 gamma(00000415)=0.129608672976453E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 415 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000415)=0.000000000000000E+00 beta (00000416)=0.130164840656182E+02 gamma(00000416)=0.130164840656182E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 416 z1= 1 -.134966712540471E-06 0.000000000000000E+00 z1= 2 -.199322867780348E-03 0.000000000000000E+00 z1= 3 -.438873687627519E-07 0.000000000000000E+00 alpha(00000416)=0.000000000000000E+00 beta (00000417)=0.119917379707661E+02 gamma(00000417)=0.119917379707661E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 417 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000417)=0.000000000000000E+00 beta (00000418)=0.128245802031703E+02 gamma(00000418)=0.128245802031703E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 418 z1= 1 0.238188450653581E-07 0.000000000000000E+00 z1= 2 -.500531202950634E-04 0.000000000000000E+00 z1= 3 -.289506813027306E-07 0.000000000000000E+00 alpha(00000418)=0.000000000000000E+00 beta (00000419)=0.132662180915147E+02 gamma(00000419)=0.132662180915147E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 419 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000419)=0.000000000000000E+00 beta (00000420)=0.137979664070681E+02 gamma(00000420)=0.137979664070681E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 420 z1= 1 -.232225050790687E-06 0.000000000000000E+00 z1= 2 0.366555303047759E-03 0.000000000000000E+00 z1= 3 -.101562542539966E-06 0.000000000000000E+00 alpha(00000420)=0.000000000000000E+00 beta (00000421)=0.125466458968733E+02 gamma(00000421)=0.125466458968733E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 421 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000421)=0.000000000000000E+00 beta (00000422)=0.142770351030955E+02 gamma(00000422)=0.142770351030955E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 422 z1= 1 -.638095655506807E-07 0.000000000000000E+00 z1= 2 -.650162756254665E-03 0.000000000000000E+00 z1= 3 -.832290452245244E-07 0.000000000000000E+00 alpha(00000422)=0.000000000000000E+00 beta (00000423)=0.124523566217418E+02 gamma(00000423)=0.124523566217418E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 423 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000423)=0.000000000000000E+00 beta (00000424)=0.131539823805698E+02 gamma(00000424)=0.131539823805698E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 424 z1= 1 -.305972260119126E-06 0.000000000000000E+00 z1= 2 0.957215133138803E-03 0.000000000000000E+00 z1= 3 -.145394016538749E-06 0.000000000000000E+00 alpha(00000424)=0.000000000000000E+00 beta (00000425)=0.127877577170263E+02 gamma(00000425)=0.127877577170263E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 425 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000425)=0.000000000000000E+00 beta (00000426)=0.142874085162117E+02 gamma(00000426)=0.142874085162117E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 426 z1= 1 -.160012666243839E-06 0.000000000000000E+00 z1= 2 -.114154395068550E-02 0.000000000000000E+00 z1= 3 -.145990409448308E-06 0.000000000000000E+00 alpha(00000426)=0.000000000000000E+00 beta (00000427)=0.130738808803287E+02 gamma(00000427)=0.130738808803287E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 427 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000427)=0.000000000000000E+00 beta (00000428)=0.144335960349537E+02 gamma(00000428)=0.144335960349537E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 428 z1= 1 -.333163358506340E-06 0.000000000000000E+00 z1= 2 0.130137171234908E-02 0.000000000000000E+00 z1= 3 -.166045568768849E-06 0.000000000000000E+00 alpha(00000428)=0.000000000000000E+00 beta (00000429)=0.124012731598750E+02 gamma(00000429)=0.124012731598750E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 429 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000429)=0.000000000000000E+00 beta (00000430)=0.135432473546613E+02 gamma(00000430)=0.135432473546613E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 430 z1= 1 -.111270516659108E-06 0.000000000000000E+00 z1= 2 -.154574166823761E-02 0.000000000000000E+00 z1= 3 -.110876397026345E-06 0.000000000000000E+00 alpha(00000430)=0.000000000000000E+00 beta (00000431)=0.127182925081315E+02 gamma(00000431)=0.127182925081315E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 431 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000431)=0.000000000000000E+00 beta (00000432)=0.136973193781518E+02 gamma(00000432)=0.136973193781518E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 432 z1= 1 -.247856865936806E-06 0.000000000000000E+00 z1= 2 0.183613119149634E-02 0.000000000000000E+00 z1= 3 -.114216467272553E-06 0.000000000000000E+00 alpha(00000432)=0.000000000000000E+00 beta (00000433)=0.128790114297009E+02 gamma(00000433)=0.128790114297009E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 433 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000433)=0.000000000000000E+00 beta (00000434)=0.140733232412104E+02 gamma(00000434)=0.140733232412104E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 434 z1= 1 -.455542592363301E-07 0.000000000000000E+00 z1= 2 -.198124416170941E-02 0.000000000000000E+00 z1= 3 -.699133777252352E-07 0.000000000000000E+00 alpha(00000434)=0.000000000000000E+00 beta (00000435)=0.118840076983000E+02 gamma(00000435)=0.118840076983000E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 435 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000435)=0.000000000000000E+00 beta (00000436)=0.130625244814100E+02 gamma(00000436)=0.130625244814100E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 436 z1= 1 -.174451681900136E-06 0.000000000000000E+00 z1= 2 0.201155734565124E-02 0.000000000000000E+00 z1= 3 -.687136820240550E-07 0.000000000000000E+00 alpha(00000436)=0.000000000000000E+00 beta (00000437)=0.122669592940488E+02 gamma(00000437)=0.122669592940488E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 437 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000437)=0.000000000000000E+00 beta (00000438)=0.138092897674172E+02 gamma(00000438)=0.138092897674172E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 438 z1= 1 -.297745798342151E-07 0.000000000000000E+00 z1= 2 -.176261527160148E-02 0.000000000000000E+00 z1= 3 -.577804975388082E-07 0.000000000000000E+00 alpha(00000438)=0.000000000000000E+00 beta (00000439)=0.133023532401607E+02 gamma(00000439)=0.133023532401607E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 439 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000439)=0.000000000000000E+00 beta (00000440)=0.134567490061772E+02 gamma(00000440)=0.134567490061772E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 440 z1= 1 -.163606346961429E-06 0.000000000000000E+00 z1= 2 0.152269461554884E-02 0.000000000000000E+00 z1= 3 -.617390223845598E-07 0.000000000000000E+00 alpha(00000440)=0.000000000000000E+00 beta (00000441)=0.133299221557474E+02 gamma(00000441)=0.133299221557474E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 441 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000441)=0.000000000000000E+00 beta (00000442)=0.135329882212161E+02 gamma(00000442)=0.135329882212161E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 442 z1= 1 -.988243386993229E-08 0.000000000000000E+00 z1= 2 -.113986953569309E-02 0.000000000000000E+00 z1= 3 -.481381283346676E-07 0.000000000000000E+00 alpha(00000442)=0.000000000000000E+00 beta (00000443)=0.124448737009166E+02 gamma(00000443)=0.124448737009166E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 443 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000443)=0.000000000000000E+00 beta (00000444)=0.136636635447780E+02 gamma(00000444)=0.136636635447780E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 444 z1= 1 -.129240109242139E-06 0.000000000000000E+00 z1= 2 0.598612263752560E-03 0.000000000000000E+00 z1= 3 -.419800623361862E-07 0.000000000000000E+00 alpha(00000444)=0.000000000000000E+00 beta (00000445)=0.133845767590090E+02 gamma(00000445)=0.133845767590090E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 445 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000445)=0.000000000000000E+00 beta (00000446)=0.136210981602147E+02 gamma(00000446)=0.136210981602147E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 446 z1= 1 0.178442210296142E-07 0.000000000000000E+00 z1= 2 -.149235933149597E-03 0.000000000000000E+00 z1= 3 -.283660269587903E-07 0.000000000000000E+00 alpha(00000446)=0.000000000000000E+00 beta (00000447)=0.132853609893512E+02 gamma(00000447)=0.132853609893512E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 447 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000447)=0.000000000000000E+00 beta (00000448)=0.134411088650801E+02 gamma(00000448)=0.134411088650801E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 448 z1= 1 -.848876628334501E-07 0.000000000000000E+00 z1= 2 -.325168519710324E-03 0.000000000000000E+00 z1= 3 -.134616429369730E-07 0.000000000000000E+00 alpha(00000448)=0.000000000000000E+00 beta (00000449)=0.127934409121092E+02 gamma(00000449)=0.127934409121092E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 449 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000449)=0.000000000000000E+00 beta (00000450)=0.127349290592367E+02 gamma(00000450)=0.127349290592367E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 450 z1= 1 0.730565246180592E-07 0.000000000000000E+00 z1= 2 0.880353987529487E-03 0.000000000000000E+00 z1= 3 0.597894713160732E-08 0.000000000000000E+00 alpha(00000450)=0.000000000000000E+00 beta (00000451)=0.127912685705500E+02 gamma(00000451)=0.127912685705500E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 451 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000451)=0.000000000000000E+00 beta (00000452)=0.130976868127765E+02 gamma(00000452)=0.130976868127765E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 452 z1= 1 -.310719365645071E-07 0.000000000000000E+00 z1= 2 -.154566432990217E-02 0.000000000000000E+00 z1= 3 0.161657487253268E-07 0.000000000000000E+00 alpha(00000452)=0.000000000000000E+00 beta (00000453)=0.120364209627607E+02 gamma(00000453)=0.120364209627607E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 453 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000453)=0.000000000000000E+00 beta (00000454)=0.141544036684863E+02 gamma(00000454)=0.141544036684863E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 454 z1= 1 0.125095641406378E-06 0.000000000000000E+00 z1= 2 0.200408757731342E-02 0.000000000000000E+00 z1= 3 0.503088924794400E-07 0.000000000000000E+00 alpha(00000454)=0.000000000000000E+00 beta (00000455)=0.124660633677411E+02 gamma(00000455)=0.124660633677411E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 455 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000455)=0.000000000000000E+00 beta (00000456)=0.140772851322806E+02 gamma(00000456)=0.140772851322806E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 456 z1= 1 0.529011016390038E-07 0.000000000000000E+00 z1= 2 -.239145188952249E-02 0.000000000000000E+00 z1= 3 0.533730419864284E-07 0.000000000000000E+00 alpha(00000456)=0.000000000000000E+00 beta (00000457)=0.120383867417692E+02 gamma(00000457)=0.120383867417692E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 457 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000457)=0.000000000000000E+00 beta (00000458)=0.135102296069284E+02 gamma(00000458)=0.135102296069284E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 458 z1= 1 0.202340997763374E-06 0.000000000000000E+00 z1= 2 0.264514701830022E-02 0.000000000000000E+00 z1= 3 0.110080841646146E-06 0.000000000000000E+00 alpha(00000458)=0.000000000000000E+00 beta (00000459)=0.128483772412094E+02 gamma(00000459)=0.128483772412094E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 459 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000459)=0.000000000000000E+00 beta (00000460)=0.138612233057335E+02 gamma(00000460)=0.138612233057335E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 460 z1= 1 0.149415728978655E-06 0.000000000000000E+00 z1= 2 -.273839094102372E-02 0.000000000000000E+00 z1= 3 0.104168359315649E-06 0.000000000000000E+00 alpha(00000460)=0.000000000000000E+00 beta (00000461)=0.132412375743173E+02 gamma(00000461)=0.132412375743173E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 461 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000461)=0.000000000000000E+00 beta (00000462)=0.132612144370430E+02 gamma(00000462)=0.132612144370430E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 462 z1= 1 0.289236900076484E-06 0.000000000000000E+00 z1= 2 0.298559418989662E-02 0.000000000000000E+00 z1= 3 0.171083840569370E-06 0.000000000000000E+00 alpha(00000462)=0.000000000000000E+00 beta (00000463)=0.120615712165098E+02 gamma(00000463)=0.120615712165098E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 463 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000463)=0.000000000000000E+00 beta (00000464)=0.130424092727290E+02 gamma(00000464)=0.130424092727290E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 464 z1= 1 0.261877810819140E-06 0.000000000000000E+00 z1= 2 -.310656770789161E-02 0.000000000000000E+00 z1= 3 0.166245092653758E-06 0.000000000000000E+00 alpha(00000464)=0.000000000000000E+00 beta (00000465)=0.126194414430341E+02 gamma(00000465)=0.126194414430341E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 465 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000465)=0.000000000000000E+00 beta (00000466)=0.138687712845478E+02 gamma(00000466)=0.138687712845478E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 466 z1= 1 0.535842443428244E-06 0.000000000000000E+00 z1= 2 0.308646584845194E-02 0.000000000000000E+00 z1= 3 0.332060638953598E-06 0.000000000000000E+00 alpha(00000466)=0.000000000000000E+00 beta (00000467)=0.124982062366056E+02 gamma(00000467)=0.124982062366056E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 467 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000467)=0.000000000000000E+00 beta (00000468)=0.131818843851236E+02 gamma(00000468)=0.131818843851236E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 468 z1= 1 0.601387439532960E-06 0.000000000000000E+00 z1= 2 -.308783355478289E-02 0.000000000000000E+00 z1= 3 0.373553506112490E-06 0.000000000000000E+00 alpha(00000468)=0.000000000000000E+00 beta (00000469)=0.131767875440572E+02 gamma(00000469)=0.131767875440572E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 469 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000469)=0.000000000000000E+00 beta (00000470)=0.143419018409636E+02 gamma(00000470)=0.143419018409636E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 470 z1= 1 0.886738543228165E-06 0.000000000000000E+00 z1= 2 0.289517265799398E-02 0.000000000000000E+00 z1= 3 0.551075778481677E-06 0.000000000000000E+00 alpha(00000470)=0.000000000000000E+00 beta (00000471)=0.127176154842224E+02 gamma(00000471)=0.127176154842224E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 471 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000471)=0.000000000000000E+00 beta (00000472)=0.137653243860276E+02 gamma(00000472)=0.137653243860276E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 472 z1= 1 0.769525339636232E-06 0.000000000000000E+00 z1= 2 -.275689823991819E-02 0.000000000000000E+00 z1= 3 0.475379533885275E-06 0.000000000000000E+00 alpha(00000472)=0.000000000000000E+00 beta (00000473)=0.125009885456473E+02 gamma(00000473)=0.125009885456473E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 473 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000473)=0.000000000000000E+00 beta (00000474)=0.138517524257596E+02 gamma(00000474)=0.138517524257596E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 474 z1= 1 0.933756862193848E-06 0.000000000000000E+00 z1= 2 0.264764833272226E-02 0.000000000000000E+00 z1= 3 0.583415745302325E-06 0.000000000000000E+00 alpha(00000474)=0.000000000000000E+00 beta (00000475)=0.127183987692066E+02 gamma(00000475)=0.127183987692066E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 475 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000475)=0.000000000000000E+00 beta (00000476)=0.132006981979750E+02 gamma(00000476)=0.132006981979750E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 476 z1= 1 0.864430863972048E-06 0.000000000000000E+00 z1= 2 -.276923113280664E-02 0.000000000000000E+00 z1= 3 0.532746382244205E-06 0.000000000000000E+00 alpha(00000476)=0.000000000000000E+00 beta (00000477)=0.131664318755451E+02 gamma(00000477)=0.131664318755451E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 477 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000477)=0.000000000000000E+00 beta (00000478)=0.147302227507037E+02 gamma(00000478)=0.147302227507037E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 478 z1= 1 0.975731397058217E-06 0.000000000000000E+00 z1= 2 0.272400304572309E-02 0.000000000000000E+00 z1= 3 0.610348095133775E-06 0.000000000000000E+00 alpha(00000478)=0.000000000000000E+00 beta (00000479)=0.127357403727713E+02 gamma(00000479)=0.127357403727713E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 479 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000479)=0.000000000000000E+00 beta (00000480)=0.135673875466831E+02 gamma(00000480)=0.135673875466831E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 480 z1= 1 0.614436737481809E-06 0.000000000000000E+00 z1= 2 -.282240492284398E-02 0.000000000000000E+00 z1= 3 0.378091468846795E-06 0.000000000000000E+00 alpha(00000480)=0.000000000000000E+00 beta (00000481)=0.125972589227143E+02 gamma(00000481)=0.125972589227143E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 481 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000481)=0.000000000000000E+00 beta (00000482)=0.137424488368691E+02 gamma(00000482)=0.137424488368691E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 482 z1= 1 0.486081565020426E-06 0.000000000000000E+00 z1= 2 0.277077884568460E-02 0.000000000000000E+00 z1= 3 0.303685939866092E-06 0.000000000000000E+00 alpha(00000482)=0.000000000000000E+00 beta (00000483)=0.126359772961699E+02 gamma(00000483)=0.126359772961699E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 483 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000483)=0.000000000000000E+00 beta (00000484)=0.138921905934038E+02 gamma(00000484)=0.138921905934038E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 484 z1= 1 0.190149186785060E-06 0.000000000000000E+00 z1= 2 -.275352434057884E-02 0.000000000000000E+00 z1= 3 0.120937910922774E-06 0.000000000000000E+00 alpha(00000484)=0.000000000000000E+00 beta (00000485)=0.129508194601096E+02 gamma(00000485)=0.129508194601096E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 485 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000485)=0.000000000000000E+00 beta (00000486)=0.135343067639628E+02 gamma(00000486)=0.135343067639628E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 486 z1= 1 0.266939341412448E-07 0.000000000000000E+00 z1= 2 0.290470450595048E-02 0.000000000000000E+00 z1= 3 0.120120059155752E-07 0.000000000000000E+00 alpha(00000486)=0.000000000000000E+00 beta (00000487)=0.125184746130337E+02 gamma(00000487)=0.125184746130337E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 487 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000487)=0.000000000000000E+00 beta (00000488)=0.132693180565626E+02 gamma(00000488)=0.132693180565626E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 488 z1= 1 -.274234194200685E-06 0.000000000000000E+00 z1= 2 -.302186916245658E-02 0.000000000000000E+00 z1= 3 -.161319625942372E-06 0.000000000000000E+00 alpha(00000488)=0.000000000000000E+00 beta (00000489)=0.128645711373471E+02 gamma(00000489)=0.128645711373471E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 489 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000489)=0.000000000000000E+00 beta (00000490)=0.137631477591659E+02 gamma(00000490)=0.137631477591659E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 490 z1= 1 -.481619379553815E-06 0.000000000000000E+00 z1= 2 0.308950918147482E-02 0.000000000000000E+00 z1= 3 -.308174272430360E-06 0.000000000000000E+00 alpha(00000490)=0.000000000000000E+00 beta (00000491)=0.131057555770830E+02 gamma(00000491)=0.131057555770830E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 491 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000491)=0.000000000000000E+00 beta (00000492)=0.128876727419474E+02 gamma(00000492)=0.128876727419474E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 492 z1= 1 -.748302364242653E-06 0.000000000000000E+00 z1= 2 -.342095891591632E-02 0.000000000000000E+00 z1= 3 -.448787731722198E-06 0.000000000000000E+00 alpha(00000492)=0.000000000000000E+00 beta (00000493)=0.122869403226374E+02 gamma(00000493)=0.122869403226374E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 493 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000493)=0.000000000000000E+00 beta (00000494)=0.141729787350497E+02 gamma(00000494)=0.141729787350497E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 494 z1= 1 -.112124052983973E-05 0.000000000000000E+00 z1= 2 0.318150894828360E-02 0.000000000000000E+00 z1= 3 -.708695275182243E-06 0.000000000000000E+00 alpha(00000494)=0.000000000000000E+00 beta (00000495)=0.119922166509718E+02 gamma(00000495)=0.119922166509718E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 495 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000495)=0.000000000000000E+00 beta (00000496)=0.139110566533087E+02 gamma(00000496)=0.139110566533087E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 496 z1= 1 -.161863802445239E-05 0.000000000000000E+00 z1= 2 -.291370503115111E-02 0.000000000000000E+00 z1= 3 -.986148446614776E-06 0.000000000000000E+00 alpha(00000496)=0.000000000000000E+00 beta (00000497)=0.124611718789860E+02 gamma(00000497)=0.124611718789860E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 497 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000497)=0.000000000000000E+00 beta (00000498)=0.137061246609462E+02 gamma(00000498)=0.137061246609462E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 498 z1= 1 -.222464455121394E-05 0.000000000000000E+00 z1= 2 0.274726577707597E-02 0.000000000000000E+00 z1= 3 -.139523030768190E-05 0.000000000000000E+00 alpha(00000498)=0.000000000000000E+00 beta (00000499)=0.120719296162846E+02 gamma(00000499)=0.120719296162846E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 499 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000499)=0.000000000000000E+00 beta (00000500)=0.133620426170775E+02 gamma(00000500)=0.133620426170775E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 500 z1= 1 -.328298254082243E-05 0.000000000000000E+00 z1= 2 -.259341297890145E-02 0.000000000000000E+00 z1= 3 -.200995562957886E-05 0.000000000000000E+00 alpha(00000500)=0.000000000000000E+00 beta (00000501)=0.125918342800555E+02 gamma(00000501)=0.125918342800555E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Norm of initial Lanczos vectors= 0.939778715656696 Starting Lanczos loop 3 Lanczos iteration: 1 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal alpha(00000001)=0.000000000000000E+00 beta (00000002)=0.199314480135303E+01 gamma(00000002)=0.199314480135303E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 2 z1= 1 -.391051520288663E-08 0.000000000000000E+00 z1= 2 -.322279387792498E-07 0.000000000000000E+00 z1= 3 0.629699734692312E+00 0.000000000000000E+00 alpha(00000002)=0.000000000000000E+00 beta (00000003)=0.670063338291405E+01 gamma(00000003)=0.670063338291405E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 3 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000003)=0.000000000000000E+00 beta (00000004)=0.145136731014409E+02 gamma(00000004)=0.145136731014409E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 4 z1= 1 0.824700098120933E-08 0.000000000000000E+00 z1= 2 0.939750789599042E-08 0.000000000000000E+00 z1= 3 -.232649523854026E+00 0.000000000000000E+00 alpha(00000004)=0.000000000000000E+00 beta (00000005)=0.122818082573469E+02 gamma(00000005)=0.122818082573469E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 5 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000005)=0.000000000000000E+00 beta (00000006)=0.140748538010301E+02 gamma(00000006)=0.140748538010301E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 6 z1= 1 -.355791501783446E-08 0.000000000000000E+00 z1= 2 -.775057238945305E-08 0.000000000000000E+00 z1= 3 0.180583073048140E+00 0.000000000000000E+00 alpha(00000006)=0.000000000000000E+00 beta (00000007)=0.125865110848194E+02 gamma(00000007)=0.125865110848194E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 7 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000007)=0.000000000000000E+00 beta (00000008)=0.137410782307505E+02 gamma(00000008)=0.137410782307505E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 8 z1= 1 -.686476994173069E-09 0.000000000000000E+00 z1= 2 0.765954018982530E-08 0.000000000000000E+00 z1= 3 -.152686489806195E+00 0.000000000000000E+00 alpha(00000008)=0.000000000000000E+00 beta (00000009)=0.127728853316437E+02 gamma(00000009)=0.127728853316437E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 9 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000009)=0.000000000000000E+00 beta (00000010)=0.137004270423829E+02 gamma(00000010)=0.137004270423829E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 10 z1= 1 0.726795026093942E-08 0.000000000000000E+00 z1= 2 -.128124026381893E-07 0.000000000000000E+00 z1= 3 0.134159791779477E+00 0.000000000000000E+00 alpha(00000010)=0.000000000000000E+00 beta (00000011)=0.128681737984524E+02 gamma(00000011)=0.128681737984524E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 11 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000011)=0.000000000000000E+00 beta (00000012)=0.137106685306504E+02 gamma(00000012)=0.137106685306504E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 12 z1= 1 -.151789364024983E-07 0.000000000000000E+00 z1= 2 0.210127180771394E-07 0.000000000000000E+00 z1= 3 -.119965571460089E+00 0.000000000000000E+00 alpha(00000012)=0.000000000000000E+00 beta (00000013)=0.128417717155475E+02 gamma(00000013)=0.128417717155475E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 13 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000013)=0.000000000000000E+00 beta (00000014)=0.137011510702496E+02 gamma(00000014)=0.137011510702496E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 14 z1= 1 0.238558921783483E-07 0.000000000000000E+00 z1= 2 -.313790835970327E-07 0.000000000000000E+00 z1= 3 0.107900617297797E+00 0.000000000000000E+00 alpha(00000014)=0.000000000000000E+00 beta (00000015)=0.128940308552715E+02 gamma(00000015)=0.128940308552715E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 15 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000015)=0.000000000000000E+00 beta (00000016)=0.137440781820439E+02 gamma(00000016)=0.137440781820439E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 16 z1= 1 -.317069497204978E-07 0.000000000000000E+00 z1= 2 0.412421372494821E-07 0.000000000000000E+00 z1= 3 -.976649800324746E-01 0.000000000000000E+00 alpha(00000016)=0.000000000000000E+00 beta (00000017)=0.128587730300052E+02 gamma(00000017)=0.128587730300052E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 17 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000017)=0.000000000000000E+00 beta (00000018)=0.135691723179518E+02 gamma(00000018)=0.135691723179518E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 18 z1= 1 0.387975090613418E-07 0.000000000000000E+00 z1= 2 -.509699877843496E-07 0.000000000000000E+00 z1= 3 0.896249382256153E-01 0.000000000000000E+00 alpha(00000018)=0.000000000000000E+00 beta (00000019)=0.127885919310831E+02 gamma(00000019)=0.127885919310831E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 19 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000019)=0.000000000000000E+00 beta (00000020)=0.135638213993692E+02 gamma(00000020)=0.135638213993692E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 20 z1= 1 -.439066456866134E-07 0.000000000000000E+00 z1= 2 0.583451006434203E-07 0.000000000000000E+00 z1= 3 -.821470430213860E-01 0.000000000000000E+00 alpha(00000020)=0.000000000000000E+00 beta (00000021)=0.128362054760325E+02 gamma(00000021)=0.128362054760325E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 21 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000021)=0.000000000000000E+00 beta (00000022)=0.136591759447272E+02 gamma(00000022)=0.136591759447272E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 22 z1= 1 0.469006307902888E-07 0.000000000000000E+00 z1= 2 -.629105725935639E-07 0.000000000000000E+00 z1= 3 0.752871748531294E-01 0.000000000000000E+00 alpha(00000022)=0.000000000000000E+00 beta (00000023)=0.129862394241386E+02 gamma(00000023)=0.129862394241386E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 23 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000023)=0.000000000000000E+00 beta (00000024)=0.134425180004805E+02 gamma(00000024)=0.134425180004805E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 24 z1= 1 -.499837243725897E-07 0.000000000000000E+00 z1= 2 0.674676459179457E-07 0.000000000000000E+00 z1= 3 -.711507137197235E-01 0.000000000000000E+00 alpha(00000024)=0.000000000000000E+00 beta (00000025)=0.126824226422534E+02 gamma(00000025)=0.126824226422534E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 25 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000025)=0.000000000000000E+00 beta (00000026)=0.137714873149064E+02 gamma(00000026)=0.137714873149064E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 26 z1= 1 0.492428427402870E-07 0.000000000000000E+00 z1= 2 -.667640372182133E-07 0.000000000000000E+00 z1= 3 0.642710153156291E-01 0.000000000000000E+00 alpha(00000026)=0.000000000000000E+00 beta (00000027)=0.130491939184484E+02 gamma(00000027)=0.130491939184484E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 27 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000027)=0.000000000000000E+00 beta (00000028)=0.135068053445330E+02 gamma(00000028)=0.135068053445330E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 28 z1= 1 -.504437137247536E-07 0.000000000000000E+00 z1= 2 0.685295116452378E-07 0.000000000000000E+00 z1= 3 -.610286115254542E-01 0.000000000000000E+00 alpha(00000028)=0.000000000000000E+00 beta (00000029)=0.130079372777013E+02 gamma(00000029)=0.130079372777013E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 29 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000029)=0.000000000000000E+00 beta (00000030)=0.137016570686847E+02 gamma(00000030)=0.137016570686847E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 30 z1= 1 0.507369269731398E-07 0.000000000000000E+00 z1= 2 -.694624816889068E-07 0.000000000000000E+00 z1= 3 0.570655315215033E-01 0.000000000000000E+00 alpha(00000030)=0.000000000000000E+00 beta (00000031)=0.128552398919192E+02 gamma(00000031)=0.128552398919192E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 31 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000031)=0.000000000000000E+00 beta (00000032)=0.135894778339260E+02 gamma(00000032)=0.135894778339260E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 32 z1= 1 -.510940624406063E-07 0.000000000000000E+00 z1= 2 0.712659049843713E-07 0.000000000000000E+00 z1= 3 -.532519121015744E-01 0.000000000000000E+00 alpha(00000032)=0.000000000000000E+00 beta (00000033)=0.128204749484895E+02 gamma(00000033)=0.128204749484895E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 33 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000033)=0.000000000000000E+00 beta (00000034)=0.137184805148576E+02 gamma(00000034)=0.137184805148576E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 34 z1= 1 0.512545039791333E-07 0.000000000000000E+00 z1= 2 -.728909537674096E-07 0.000000000000000E+00 z1= 3 0.491434931309924E-01 0.000000000000000E+00 alpha(00000034)=0.000000000000000E+00 beta (00000035)=0.126970619815644E+02 gamma(00000035)=0.126970619815644E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 35 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000035)=0.000000000000000E+00 beta (00000036)=0.133797824646812E+02 gamma(00000036)=0.133797824646812E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 36 z1= 1 -.530256466964307E-07 0.000000000000000E+00 z1= 2 0.775052587881700E-07 0.000000000000000E+00 z1= 3 -.460173907406523E-01 0.000000000000000E+00 alpha(00000036)=0.000000000000000E+00 beta (00000037)=0.129598327456069E+02 gamma(00000037)=0.129598327456069E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 37 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000037)=0.000000000000000E+00 beta (00000038)=0.134637146797040E+02 gamma(00000038)=0.134637146797040E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 38 z1= 1 0.566106227320798E-07 0.000000000000000E+00 z1= 2 -.852084497471924E-07 0.000000000000000E+00 z1= 3 0.437619915459657E-01 0.000000000000000E+00 alpha(00000038)=0.000000000000000E+00 beta (00000039)=0.129519594664835E+02 gamma(00000039)=0.129519594664835E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 39 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000039)=0.000000000000000E+00 beta (00000040)=0.134361828798481E+02 gamma(00000040)=0.134361828798481E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 40 z1= 1 -.606491029680675E-07 0.000000000000000E+00 z1= 2 0.936814753258776E-07 0.000000000000000E+00 z1= 3 -.417117347137787E-01 0.000000000000000E+00 alpha(00000040)=0.000000000000000E+00 beta (00000041)=0.128131243953608E+02 gamma(00000041)=0.128131243953608E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 41 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000041)=0.000000000000000E+00 beta (00000042)=0.136904432338816E+02 gamma(00000042)=0.136904432338816E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 42 z1= 1 0.625576085271692E-07 0.000000000000000E+00 z1= 2 -.992481810409718E-07 0.000000000000000E+00 z1= 3 0.385860163368195E-01 0.000000000000000E+00 alpha(00000042)=0.000000000000000E+00 beta (00000043)=0.127838989379350E+02 gamma(00000043)=0.127838989379350E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 43 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000043)=0.000000000000000E+00 beta (00000044)=0.135912153758375E+02 gamma(00000044)=0.135912153758375E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 44 z1= 1 -.654268096931588E-07 0.000000000000000E+00 z1= 2 0.105568337298474E-06 0.000000000000000E+00 z1= 3 -.358747283386162E-01 0.000000000000000E+00 alpha(00000044)=0.000000000000000E+00 beta (00000045)=0.125361805220253E+02 gamma(00000045)=0.125361805220253E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 45 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000045)=0.000000000000000E+00 beta (00000046)=0.133760149006153E+02 gamma(00000046)=0.133760149006153E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 46 z1= 1 0.688233102143698E-07 0.000000000000000E+00 z1= 2 -.112117893624579E-06 0.000000000000000E+00 z1= 3 0.331846931666148E-01 0.000000000000000E+00 alpha(00000046)=0.000000000000000E+00 beta (00000047)=0.125069520439237E+02 gamma(00000047)=0.125069520439237E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 47 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000047)=0.000000000000000E+00 beta (00000048)=0.136080029079026E+02 gamma(00000048)=0.136080029079026E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 48 z1= 1 -.708881811611233E-07 0.000000000000000E+00 z1= 2 0.116234366190175E-06 0.000000000000000E+00 z1= 3 -.300255543862818E-01 0.000000000000000E+00 alpha(00000048)=0.000000000000000E+00 beta (00000049)=0.131223658272186E+02 gamma(00000049)=0.131223658272186E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 49 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000049)=0.000000000000000E+00 beta (00000050)=0.138460103420825E+02 gamma(00000050)=0.138460103420825E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 50 z1= 1 0.747806380371491E-07 0.000000000000000E+00 z1= 2 -.122608646125981E-06 0.000000000000000E+00 z1= 3 0.280696748492818E-01 0.000000000000000E+00 alpha(00000050)=0.000000000000000E+00 beta (00000051)=0.127731426585954E+02 gamma(00000051)=0.127731426585954E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 51 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000051)=0.000000000000000E+00 beta (00000052)=0.133798775697439E+02 gamma(00000052)=0.133798775697439E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 52 z1= 1 -.788344926397930E-07 0.000000000000000E+00 z1= 2 0.128940038091106E-06 0.000000000000000E+00 z1= 3 -.264229048445805E-01 0.000000000000000E+00 alpha(00000052)=0.000000000000000E+00 beta (00000053)=0.126315017811630E+02 gamma(00000053)=0.126315017811630E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 53 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000053)=0.000000000000000E+00 beta (00000054)=0.132873852529967E+02 gamma(00000054)=0.132873852529967E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 54 z1= 1 0.817399528668574E-07 0.000000000000000E+00 z1= 2 -.132666961277458E-06 0.000000000000000E+00 z1= 3 0.247455227563047E-01 0.000000000000000E+00 alpha(00000054)=0.000000000000000E+00 beta (00000055)=0.133543413577501E+02 gamma(00000055)=0.133543413577501E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 55 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000055)=0.000000000000000E+00 beta (00000056)=0.135611655223615E+02 gamma(00000056)=0.135611655223615E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 56 z1= 1 -.874354706835619E-07 0.000000000000000E+00 z1= 2 0.141019529531039E-06 0.000000000000000E+00 z1= 3 -.240546082393327E-01 0.000000000000000E+00 alpha(00000056)=0.000000000000000E+00 beta (00000057)=0.131772744743939E+02 gamma(00000057)=0.131772744743939E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 57 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000057)=0.000000000000000E+00 beta (00000058)=0.132235074437473E+02 gamma(00000058)=0.132235074437473E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 58 z1= 1 0.944096713692728E-07 0.000000000000000E+00 z1= 2 -.151542856278910E-06 0.000000000000000E+00 z1= 3 0.236685792326564E-01 0.000000000000000E+00 alpha(00000058)=0.000000000000000E+00 beta (00000059)=0.127640907403670E+02 gamma(00000059)=0.127640907403670E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 59 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000059)=0.000000000000000E+00 beta (00000060)=0.136257164760421E+02 gamma(00000060)=0.136257164760421E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 60 z1= 1 -.953614048902589E-07 0.000000000000000E+00 z1= 2 0.151512871916044E-06 0.000000000000000E+00 z1= 3 -.218999084865738E-01 0.000000000000000E+00 alpha(00000060)=0.000000000000000E+00 beta (00000061)=0.132790718328051E+02 gamma(00000061)=0.132790718328051E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 61 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000061)=0.000000000000000E+00 beta (00000062)=0.139030699681327E+02 gamma(00000062)=0.139030699681327E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 62 z1= 1 0.982154899748476E-07 0.000000000000000E+00 z1= 2 -.154104811996361E-06 0.000000000000000E+00 z1= 3 0.206469559429609E-01 0.000000000000000E+00 alpha(00000062)=0.000000000000000E+00 beta (00000063)=0.131183051947458E+02 gamma(00000063)=0.131183051947458E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 63 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000063)=0.000000000000000E+00 beta (00000064)=0.135405065813555E+02 gamma(00000064)=0.135405065813555E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 64 z1= 1 -.103040743049555E-06 0.000000000000000E+00 z1= 2 0.159406208060037E-06 0.000000000000000E+00 z1= 3 -.197046382676075E-01 0.000000000000000E+00 alpha(00000064)=0.000000000000000E+00 beta (00000065)=0.125391289720173E+02 gamma(00000065)=0.125391289720173E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 65 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000065)=0.000000000000000E+00 beta (00000066)=0.134390302037820E+02 gamma(00000066)=0.134390302037820E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 66 z1= 1 0.104754388460457E-06 0.000000000000000E+00 z1= 2 -.159971556605359E-06 0.000000000000000E+00 z1= 3 0.181131058821595E-01 0.000000000000000E+00 alpha(00000066)=0.000000000000000E+00 beta (00000067)=0.132140240608874E+02 gamma(00000067)=0.132140240608874E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 67 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000067)=0.000000000000000E+00 beta (00000068)=0.138620818696257E+02 gamma(00000068)=0.138620818696257E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 68 z1= 1 -.107765865020549E-06 0.000000000000000E+00 z1= 2 0.162855201676351E-06 0.000000000000000E+00 z1= 3 -.171057578281943E-01 0.000000000000000E+00 alpha(00000068)=0.000000000000000E+00 beta (00000069)=0.130348417912121E+02 gamma(00000069)=0.130348417912121E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 69 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000069)=0.000000000000000E+00 beta (00000070)=0.133201127023590E+02 gamma(00000070)=0.133201127023590E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 70 z1= 1 0.114292744280266E-06 0.000000000000000E+00 z1= 2 -.170702514259297E-06 0.000000000000000E+00 z1= 3 0.165989992603207E-01 0.000000000000000E+00 alpha(00000070)=0.000000000000000E+00 beta (00000071)=0.128104086794958E+02 gamma(00000071)=0.128104086794958E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 71 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000071)=0.000000000000000E+00 beta (00000072)=0.139896049899020E+02 gamma(00000072)=0.139896049899020E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 72 z1= 1 -.113890661637478E-06 0.000000000000000E+00 z1= 2 0.168303696112138E-06 0.000000000000000E+00 z1= 3 -.150836894923752E-01 0.000000000000000E+00 alpha(00000072)=0.000000000000000E+00 beta (00000073)=0.128218329539661E+02 gamma(00000073)=0.128218329539661E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 73 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000073)=0.000000000000000E+00 beta (00000074)=0.132875919076532E+02 gamma(00000074)=0.132875919076532E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 74 z1= 1 0.119878354449914E-06 0.000000000000000E+00 z1= 2 -.174749471393938E-06 0.000000000000000E+00 z1= 3 0.144443802348645E-01 0.000000000000000E+00 alpha(00000074)=0.000000000000000E+00 beta (00000075)=0.122804827169993E+02 gamma(00000075)=0.122804827169993E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 75 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000075)=0.000000000000000E+00 beta (00000076)=0.134548952266221E+02 gamma(00000076)=0.134548952266221E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 76 z1= 1 -.119820312024935E-06 0.000000000000000E+00 z1= 2 0.172066219474671E-06 0.000000000000000E+00 z1= 3 -.131039077809855E-01 0.000000000000000E+00 alpha(00000076)=0.000000000000000E+00 beta (00000077)=0.128673819957135E+02 gamma(00000077)=0.128673819957135E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 77 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000077)=0.000000000000000E+00 beta (00000078)=0.139740044769493E+02 gamma(00000078)=0.139740044769493E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 78 z1= 1 0.121716937895127E-06 0.000000000000000E+00 z1= 2 -.172216993537719E-06 0.000000000000000E+00 z1= 3 0.120552420205074E-01 0.000000000000000E+00 alpha(00000078)=0.000000000000000E+00 beta (00000079)=0.127688481173864E+02 gamma(00000079)=0.127688481173864E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 79 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000079)=0.000000000000000E+00 beta (00000080)=0.134060381457985E+02 gamma(00000080)=0.134060381457985E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 80 z1= 1 -.128733135234605E-06 0.000000000000000E+00 z1= 2 0.179191429360427E-06 0.000000000000000E+00 z1= 3 -.115191324325211E-01 0.000000000000000E+00 alpha(00000080)=0.000000000000000E+00 beta (00000081)=0.127014914860411E+02 gamma(00000081)=0.127014914860411E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 81 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000081)=0.000000000000000E+00 beta (00000082)=0.140476862297257E+02 gamma(00000082)=0.140476862297257E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 82 z1= 1 0.128537156366543E-06 0.000000000000000E+00 z1= 2 -.176378005689853E-06 0.000000000000000E+00 z1= 3 0.104894678444297E-01 0.000000000000000E+00 alpha(00000082)=0.000000000000000E+00 beta (00000083)=0.128227082188020E+02 gamma(00000083)=0.128227082188020E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 83 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000083)=0.000000000000000E+00 beta (00000084)=0.131465150443924E+02 gamma(00000084)=0.131465150443924E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 84 z1= 1 -.138036238713423E-06 0.000000000000000E+00 z1= 2 0.186476858275361E-06 0.000000000000000E+00 z1= 3 -.103253734292651E-01 0.000000000000000E+00 alpha(00000084)=0.000000000000000E+00 beta (00000085)=0.129169629635369E+02 gamma(00000085)=0.129169629635369E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 85 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000085)=0.000000000000000E+00 beta (00000086)=0.141724383431590E+02 gamma(00000086)=0.141724383431590E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 86 z1= 1 0.137503672600306E-06 0.000000000000000E+00 z1= 2 -.183800093554514E-06 0.000000000000000E+00 z1= 3 0.937915763904323E-02 0.000000000000000E+00 alpha(00000086)=0.000000000000000E+00 beta (00000087)=0.126042120779657E+02 gamma(00000087)=0.126042120779657E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 87 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000087)=0.000000000000000E+00 beta (00000088)=0.133572267013235E+02 gamma(00000088)=0.133572267013235E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 88 z1= 1 -.143806870181511E-06 0.000000000000000E+00 z1= 2 0.191440835207177E-06 0.000000000000000E+00 z1= 3 -.866888359454643E-02 0.000000000000000E+00 alpha(00000088)=0.000000000000000E+00 beta (00000089)=0.129319547670832E+02 gamma(00000089)=0.129319547670832E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 89 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000089)=0.000000000000000E+00 beta (00000090)=0.137666348287321E+02 gamma(00000090)=0.137666348287321E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 90 z1= 1 0.148519415493417E-06 0.000000000000000E+00 z1= 2 -.196516304342361E-06 0.000000000000000E+00 z1= 3 0.790769373418742E-02 0.000000000000000E+00 alpha(00000090)=0.000000000000000E+00 beta (00000091)=0.125045608096966E+02 gamma(00000091)=0.125045608096966E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 91 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000091)=0.000000000000000E+00 beta (00000092)=0.129404252362006E+02 gamma(00000092)=0.129404252362006E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 92 z1= 1 -.158848438723135E-06 0.000000000000000E+00 z1= 2 0.208867744582375E-06 0.000000000000000E+00 z1= 3 -.741079444031703E-02 0.000000000000000E+00 alpha(00000092)=0.000000000000000E+00 beta (00000093)=0.134311026516850E+02 gamma(00000093)=0.134311026516850E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 93 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000093)=0.000000000000000E+00 beta (00000094)=0.132437624326730E+02 gamma(00000094)=0.132437624326730E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 94 z1= 1 0.174782575648518E-06 0.000000000000000E+00 z1= 2 -.229023186314875E-06 0.000000000000000E+00 z1= 3 0.733579150027077E-02 0.000000000000000E+00 alpha(00000094)=0.000000000000000E+00 beta (00000095)=0.124429538733711E+02 gamma(00000095)=0.124429538733711E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 95 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000095)=0.000000000000000E+00 beta (00000096)=0.130304948706799E+02 gamma(00000096)=0.130304948706799E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 96 z1= 1 -.181271451810605E-06 0.000000000000000E+00 z1= 2 0.237382440692658E-06 0.000000000000000E+00 z1= 3 -.684848101121330E-02 0.000000000000000E+00 alpha(00000096)=0.000000000000000E+00 beta (00000097)=0.127892159132966E+02 gamma(00000097)=0.127892159132966E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 97 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000097)=0.000000000000000E+00 beta (00000098)=0.128270162774085E+02 gamma(00000098)=0.128270162774085E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 98 z1= 1 0.195515330557667E-06 0.000000000000000E+00 z1= 2 -.257123872833060E-06 0.000000000000000E+00 z1= 3 0.663203573971833E-02 0.000000000000000E+00 alpha(00000098)=0.000000000000000E+00 beta (00000099)=0.121409226013922E+02 gamma(00000099)=0.121409226013922E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 99 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000099)=0.000000000000000E+00 beta (00000100)=0.136038303129382E+02 gamma(00000100)=0.136038303129382E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 100 z1= 1 -.187114829028247E-06 0.000000000000000E+00 z1= 2 0.247102154931960E-06 0.000000000000000E+00 z1= 3 -.578329996204183E-02 0.000000000000000E+00 alpha(00000100)=0.000000000000000E+00 beta (00000101)=0.129656539498620E+02 gamma(00000101)=0.129656539498620E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 101 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000101)=0.000000000000000E+00 beta (00000102)=0.131118306214773E+02 gamma(00000102)=0.131118306214773E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 102 z1= 1 0.196986645866607E-06 0.000000000000000E+00 z1= 2 -.262597394449018E-06 0.000000000000000E+00 z1= 3 0.575069474334131E-02 0.000000000000000E+00 alpha(00000102)=0.000000000000000E+00 beta (00000103)=0.136938635919382E+02 gamma(00000103)=0.136938635919382E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 103 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000103)=0.000000000000000E+00 beta (00000104)=0.133882029444534E+02 gamma(00000104)=0.133882029444534E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 104 z1= 1 -.211235285992243E-06 0.000000000000000E+00 z1= 2 0.284756642803018E-06 0.000000000000000E+00 z1= 3 -.609540589920683E-02 0.000000000000000E+00 alpha(00000104)=0.000000000000000E+00 beta (00000105)=0.130441761765302E+02 gamma(00000105)=0.130441761765302E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 105 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000105)=0.000000000000000E+00 beta (00000106)=0.141232666540605E+02 gamma(00000106)=0.141232666540605E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 106 z1= 1 0.204560538446510E-06 0.000000000000000E+00 z1= 2 -.279259257244310E-06 0.000000000000000E+00 z1= 3 0.588739296122635E-02 0.000000000000000E+00 alpha(00000106)=0.000000000000000E+00 beta (00000107)=0.131966668829271E+02 gamma(00000107)=0.131966668829271E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 107 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000107)=0.000000000000000E+00 beta (00000108)=0.134607525776882E+02 gamma(00000108)=0.134607525776882E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 108 z1= 1 -.210998840201142E-06 0.000000000000000E+00 z1= 2 0.291881171533229E-06 0.000000000000000E+00 z1= 3 -.602260956139738E-02 0.000000000000000E+00 alpha(00000108)=0.000000000000000E+00 beta (00000109)=0.135930215811041E+02 gamma(00000109)=0.135930215811041E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 109 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000109)=0.000000000000000E+00 beta (00000110)=0.125435595324441E+02 gamma(00000110)=0.125435595324441E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 110 z1= 1 0.239685134064685E-06 0.000000000000000E+00 z1= 2 -.334959661250044E-06 0.000000000000000E+00 z1= 3 0.671350272477940E-02 0.000000000000000E+00 alpha(00000110)=0.000000000000000E+00 beta (00000111)=0.131064300653527E+02 gamma(00000111)=0.131064300653527E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 111 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000111)=0.000000000000000E+00 beta (00000112)=0.137148857225394E+02 gamma(00000112)=0.137148857225394E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 112 z1= 1 -.238102956912154E-06 0.000000000000000E+00 z1= 2 0.335560951551664E-06 0.000000000000000E+00 z1= 3 -.655039928450506E-02 0.000000000000000E+00 alpha(00000112)=0.000000000000000E+00 beta (00000113)=0.127404509291042E+02 gamma(00000113)=0.127404509291042E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 113 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000113)=0.000000000000000E+00 beta (00000114)=0.137207991312718E+02 gamma(00000114)=0.137207991312718E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 114 z1= 1 0.228535228209638E-06 0.000000000000000E+00 z1= 2 -.324414851035149E-06 0.000000000000000E+00 z1= 3 0.624097745813762E-02 0.000000000000000E+00 alpha(00000114)=0.000000000000000E+00 beta (00000115)=0.119984389299803E+02 gamma(00000115)=0.119984389299803E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 115 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000115)=0.000000000000000E+00 beta (00000116)=0.137000629373856E+02 gamma(00000116)=0.137000629373856E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 116 z1= 1 -.208068825598129E-06 0.000000000000000E+00 z1= 2 0.298204094726934E-06 0.000000000000000E+00 z1= 3 -.572374128750085E-02 0.000000000000000E+00 alpha(00000116)=0.000000000000000E+00 beta (00000117)=0.124256703358991E+02 gamma(00000117)=0.124256703358991E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 117 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000117)=0.000000000000000E+00 beta (00000118)=0.134796474069477E+02 gamma(00000118)=0.134796474069477E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 118 z1= 1 0.200170551831641E-06 0.000000000000000E+00 z1= 2 -.289378073603779E-06 0.000000000000000E+00 z1= 3 0.548267162113758E-02 0.000000000000000E+00 alpha(00000118)=0.000000000000000E+00 beta (00000119)=0.128590938561399E+02 gamma(00000119)=0.128590938561399E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 119 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000119)=0.000000000000000E+00 beta (00000120)=0.134053466894004E+02 gamma(00000120)=0.134053466894004E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 120 z1= 1 -.199494090873293E-06 0.000000000000000E+00 z1= 2 0.290106249253657E-06 0.000000000000000E+00 z1= 3 -.535944222037767E-02 0.000000000000000E+00 alpha(00000120)=0.000000000000000E+00 beta (00000121)=0.127605137714466E+02 gamma(00000121)=0.127605137714466E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 121 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000121)=0.000000000000000E+00 beta (00000122)=0.133448003898517E+02 gamma(00000122)=0.133448003898517E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 122 z1= 1 0.197626814214206E-06 0.000000000000000E+00 z1= 2 -.288836295646430E-06 0.000000000000000E+00 z1= 3 0.514309671397373E-02 0.000000000000000E+00 alpha(00000122)=0.000000000000000E+00 beta (00000123)=0.127224540486530E+02 gamma(00000123)=0.127224540486530E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 123 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000123)=0.000000000000000E+00 beta (00000124)=0.134570338007467E+02 gamma(00000124)=0.134570338007467E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 124 z1= 1 -.192895650798089E-06 0.000000000000000E+00 z1= 2 0.283169818381698E-06 0.000000000000000E+00 z1= 3 -.484972014622914E-02 0.000000000000000E+00 alpha(00000124)=0.000000000000000E+00 beta (00000125)=0.129005340368556E+02 gamma(00000125)=0.129005340368556E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 125 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000125)=0.000000000000000E+00 beta (00000126)=0.137360716514373E+02 gamma(00000126)=0.137360716514373E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 126 z1= 1 0.187268738016666E-06 0.000000000000000E+00 z1= 2 -.276702488895839E-06 0.000000000000000E+00 z1= 3 0.460510310548476E-02 0.000000000000000E+00 alpha(00000126)=0.000000000000000E+00 beta (00000127)=0.128192882406961E+02 gamma(00000127)=0.128192882406961E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 127 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000127)=0.000000000000000E+00 beta (00000128)=0.138278612271977E+02 gamma(00000128)=0.138278612271977E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 128 z1= 1 -.179458679446963E-06 0.000000000000000E+00 z1= 2 0.266214565839435E-06 0.000000000000000E+00 z1= 3 -.438246110412841E-02 0.000000000000000E+00 alpha(00000128)=0.000000000000000E+00 beta (00000129)=0.132954719689928E+02 gamma(00000129)=0.132954719689928E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 129 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000129)=0.000000000000000E+00 beta (00000130)=0.135447791007428E+02 gamma(00000130)=0.135447791007428E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 130 z1= 1 0.181773028133398E-06 0.000000000000000E+00 z1= 2 -.269868239894592E-06 0.000000000000000E+00 z1= 3 0.440976521220558E-02 0.000000000000000E+00 alpha(00000130)=0.000000000000000E+00 beta (00000131)=0.125749771564993E+02 gamma(00000131)=0.125749771564993E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 131 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000131)=0.000000000000000E+00 beta (00000132)=0.135691610322388E+02 gamma(00000132)=0.135691610322388E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 132 z1= 1 -.175129073410208E-06 0.000000000000000E+00 z1= 2 0.259691921835432E-06 0.000000000000000E+00 z1= 3 -.410270216838956E-02 0.000000000000000E+00 alpha(00000132)=0.000000000000000E+00 beta (00000133)=0.125411188781498E+02 gamma(00000133)=0.125411188781498E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 133 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000133)=0.000000000000000E+00 beta (00000134)=0.135110542409935E+02 gamma(00000134)=0.135110542409935E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 134 z1= 1 0.169650931082857E-06 0.000000000000000E+00 z1= 2 -.250782333685281E-06 0.000000000000000E+00 z1= 3 0.375442259722447E-02 0.000000000000000E+00 alpha(00000134)=0.000000000000000E+00 beta (00000135)=0.127015230647543E+02 gamma(00000135)=0.127015230647543E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 135 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000135)=0.000000000000000E+00 beta (00000136)=0.137731859278237E+02 gamma(00000136)=0.137731859278237E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 136 z1= 1 -.163076236576749E-06 0.000000000000000E+00 z1= 2 0.240549712456637E-06 0.000000000000000E+00 z1= 3 -.336089167691109E-02 0.000000000000000E+00 alpha(00000136)=0.000000000000000E+00 beta (00000137)=0.127543175207264E+02 gamma(00000137)=0.127543175207264E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 137 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000137)=0.000000000000000E+00 beta (00000138)=0.130998890414508E+02 gamma(00000138)=0.130998890414508E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 138 z1= 1 0.165309951836762E-06 0.000000000000000E+00 z1= 2 -.242418778260024E-06 0.000000000000000E+00 z1= 3 0.320288896029217E-02 0.000000000000000E+00 alpha(00000138)=0.000000000000000E+00 beta (00000139)=0.124440172355502E+02 gamma(00000139)=0.124440172355502E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 139 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000139)=0.000000000000000E+00 beta (00000140)=0.138474347069085E+02 gamma(00000140)=0.138474347069085E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 140 z1= 1 -.154929505495074E-06 0.000000000000000E+00 z1= 2 0.226042955356592E-06 0.000000000000000E+00 z1= 3 -.293329504754706E-02 0.000000000000000E+00 alpha(00000140)=0.000000000000000E+00 beta (00000141)=0.131458624644987E+02 gamma(00000141)=0.131458624644987E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 141 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000141)=0.000000000000000E+00 beta (00000142)=0.135271010629270E+02 gamma(00000142)=0.135271010629270E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 142 z1= 1 0.157816842552561E-06 0.000000000000000E+00 z1= 2 -.229726908262018E-06 0.000000000000000E+00 z1= 3 0.300419523447552E-02 0.000000000000000E+00 alpha(00000142)=0.000000000000000E+00 beta (00000143)=0.126296368938954E+02 gamma(00000143)=0.126296368938954E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 143 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000143)=0.000000000000000E+00 beta (00000144)=0.135905489795612E+02 gamma(00000144)=0.135905489795612E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 144 z1= 1 -.154343865266054E-06 0.000000000000000E+00 z1= 2 0.224377249300432E-06 0.000000000000000E+00 z1= 3 -.304594373549840E-02 0.000000000000000E+00 alpha(00000144)=0.000000000000000E+00 beta (00000145)=0.131395610544704E+02 gamma(00000145)=0.131395610544704E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 145 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000145)=0.000000000000000E+00 beta (00000146)=0.139085304829361E+02 gamma(00000146)=0.139085304829361E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 146 z1= 1 0.153520399283368E-06 0.000000000000000E+00 z1= 2 -.222628941266064E-06 0.000000000000000E+00 z1= 3 0.313634440181422E-02 0.000000000000000E+00 alpha(00000146)=0.000000000000000E+00 beta (00000147)=0.132398656892532E+02 gamma(00000147)=0.132398656892532E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 147 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000147)=0.000000000000000E+00 beta (00000148)=0.138453810089322E+02 gamma(00000148)=0.138453810089322E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 148 z1= 1 -.154942105583906E-06 0.000000000000000E+00 z1= 2 0.223387089570183E-06 0.000000000000000E+00 z1= 3 -.318850632851894E-02 0.000000000000000E+00 alpha(00000148)=0.000000000000000E+00 beta (00000149)=0.128467233385648E+02 gamma(00000149)=0.128467233385648E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 149 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000149)=0.000000000000000E+00 beta (00000150)=0.133348063618793E+02 gamma(00000150)=0.133348063618793E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 150 z1= 1 0.157944513028965E-06 0.000000000000000E+00 z1= 2 -.226223803547940E-06 0.000000000000000E+00 z1= 3 0.324329374197918E-02 0.000000000000000E+00 alpha(00000150)=0.000000000000000E+00 beta (00000151)=0.126505455303267E+02 gamma(00000151)=0.126505455303267E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 151 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000151)=0.000000000000000E+00 beta (00000152)=0.138852439667764E+02 gamma(00000152)=0.138852439667764E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 152 z1= 1 -.151727563950160E-06 0.000000000000000E+00 z1= 2 0.215918666881415E-06 0.000000000000000E+00 z1= 3 -.302713563658556E-02 0.000000000000000E+00 alpha(00000152)=0.000000000000000E+00 beta (00000153)=0.127834204211855E+02 gamma(00000153)=0.127834204211855E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 153 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000153)=0.000000000000000E+00 beta (00000154)=0.141175286915022E+02 gamma(00000154)=0.141175286915022E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 154 z1= 1 0.145300676526435E-06 0.000000000000000E+00 z1= 2 -.206136585167212E-06 0.000000000000000E+00 z1= 3 0.276118186058003E-02 0.000000000000000E+00 alpha(00000154)=0.000000000000000E+00 beta (00000155)=0.125123412929354E+02 gamma(00000155)=0.125123412929354E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 155 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000155)=0.000000000000000E+00 beta (00000156)=0.132693150990575E+02 gamma(00000156)=0.132693150990575E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 156 z1= 1 -.145891808041483E-06 0.000000000000000E+00 z1= 2 0.207467689408800E-06 0.000000000000000E+00 z1= 3 -.263252227039815E-02 0.000000000000000E+00 alpha(00000156)=0.000000000000000E+00 beta (00000157)=0.126048876868744E+02 gamma(00000157)=0.126048876868744E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 157 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000157)=0.000000000000000E+00 beta (00000158)=0.137949410001994E+02 gamma(00000158)=0.137949410001994E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 158 z1= 1 0.141271162495342E-06 0.000000000000000E+00 z1= 2 -.201146852950177E-06 0.000000000000000E+00 z1= 3 0.237104204939535E-02 0.000000000000000E+00 alpha(00000158)=0.000000000000000E+00 beta (00000159)=0.130584183344663E+02 gamma(00000159)=0.130584183344663E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 159 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000159)=0.000000000000000E+00 beta (00000160)=0.138031363745694E+02 gamma(00000160)=0.138031363745694E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 160 z1= 1 -.141980773526058E-06 0.000000000000000E+00 z1= 2 0.201959335283976E-06 0.000000000000000E+00 z1= 3 -.217732395118658E-02 0.000000000000000E+00 alpha(00000160)=0.000000000000000E+00 beta (00000161)=0.129234967066293E+02 gamma(00000161)=0.129234967066293E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 161 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000161)=0.000000000000000E+00 beta (00000162)=0.133298282868454E+02 gamma(00000162)=0.133298282868454E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 162 z1= 1 0.146428802541457E-06 0.000000000000000E+00 z1= 2 -.208549574655338E-06 0.000000000000000E+00 z1= 3 0.200129929591841E-02 0.000000000000000E+00 alpha(00000162)=0.000000000000000E+00 beta (00000163)=0.124682400917869E+02 gamma(00000163)=0.124682400917869E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 163 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000163)=0.000000000000000E+00 beta (00000164)=0.134658114701272E+02 gamma(00000164)=0.134658114701272E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 164 z1= 1 -.143886127029584E-06 0.000000000000000E+00 z1= 2 0.206133881977110E-06 0.000000000000000E+00 z1= 3 -.164558134949362E-02 0.000000000000000E+00 alpha(00000164)=0.000000000000000E+00 beta (00000165)=0.128624682632700E+02 gamma(00000165)=0.128624682632700E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 165 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000165)=0.000000000000000E+00 beta (00000166)=0.137346233521049E+02 gamma(00000166)=0.137346233521049E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 166 z1= 1 0.142587090567960E-06 0.000000000000000E+00 z1= 2 -.206277480913346E-06 0.000000000000000E+00 z1= 3 0.125847716690316E-02 0.000000000000000E+00 alpha(00000166)=0.000000000000000E+00 beta (00000167)=0.126784918173564E+02 gamma(00000167)=0.126784918173564E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 167 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000167)=0.000000000000000E+00 beta (00000168)=0.142370266735037E+02 gamma(00000168)=0.142370266735037E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 168 z1= 1 -.133854815981271E-06 0.000000000000000E+00 z1= 2 0.195665083716379E-06 0.000000000000000E+00 z1= 3 -.852405285814241E-03 0.000000000000000E+00 alpha(00000168)=0.000000000000000E+00 beta (00000169)=0.122884003695294E+02 gamma(00000169)=0.122884003695294E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 169 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000169)=0.000000000000000E+00 beta (00000170)=0.139332129458564E+02 gamma(00000170)=0.139332129458564E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 170 z1= 1 0.125029659679460E-06 0.000000000000000E+00 z1= 2 -.184989498982992E-06 0.000000000000000E+00 z1= 3 0.606194250412757E-03 0.000000000000000E+00 alpha(00000170)=0.000000000000000E+00 beta (00000171)=0.130755805669128E+02 gamma(00000171)=0.130755805669128E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 171 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000171)=0.000000000000000E+00 beta (00000172)=0.136261962523329E+02 gamma(00000172)=0.136261962523329E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 172 z1= 1 -.127357252172609E-06 0.000000000000000E+00 z1= 2 0.190554467876082E-06 0.000000000000000E+00 z1= 3 -.481806469740838E-03 0.000000000000000E+00 alpha(00000172)=0.000000000000000E+00 beta (00000173)=0.121894701028538E+02 gamma(00000173)=0.121894701028538E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 173 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000173)=0.000000000000000E+00 beta (00000174)=0.133774799034927E+02 gamma(00000174)=0.133774799034927E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 174 z1= 1 0.124362686698275E-06 0.000000000000000E+00 z1= 2 -.187323522982211E-06 0.000000000000000E+00 z1= 3 0.329036936816837E-03 0.000000000000000E+00 alpha(00000174)=0.000000000000000E+00 beta (00000175)=0.130321709594727E+02 gamma(00000175)=0.130321709594727E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 175 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000175)=0.000000000000000E+00 beta (00000176)=0.135964562084996E+02 gamma(00000176)=0.135964562084996E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 176 z1= 1 -.127462236883475E-06 0.000000000000000E+00 z1= 2 0.192087156434672E-06 0.000000000000000E+00 z1= 3 -.201461529064605E-03 0.000000000000000E+00 alpha(00000176)=0.000000000000000E+00 beta (00000177)=0.131049348870423E+02 gamma(00000177)=0.131049348870423E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 177 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000177)=0.000000000000000E+00 beta (00000178)=0.137484369731261E+02 gamma(00000178)=0.137484369731261E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 178 z1= 1 0.128349884635868E-06 0.000000000000000E+00 z1= 2 -.192848697562085E-06 0.000000000000000E+00 z1= 3 0.451956290578523E-04 0.000000000000000E+00 alpha(00000178)=0.000000000000000E+00 beta (00000179)=0.125767396875278E+02 gamma(00000179)=0.125767396875278E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 179 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000179)=0.000000000000000E+00 beta (00000180)=0.132901869456243E+02 gamma(00000180)=0.132901869456243E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 180 z1= 1 -.128475217144562E-06 0.000000000000000E+00 z1= 2 0.192886307867580E-06 0.000000000000000E+00 z1= 3 0.877503429521191E-04 0.000000000000000E+00 alpha(00000180)=0.000000000000000E+00 beta (00000181)=0.126737442334711E+02 gamma(00000181)=0.126737442334711E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 181 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000181)=0.000000000000000E+00 beta (00000182)=0.136833902672168E+02 gamma(00000182)=0.136833902672168E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 182 z1= 1 0.124930437134674E-06 0.000000000000000E+00 z1= 2 -.188548710257494E-06 0.000000000000000E+00 z1= 3 -.212028799333672E-03 0.000000000000000E+00 alpha(00000182)=0.000000000000000E+00 beta (00000183)=0.127712579178174E+02 gamma(00000183)=0.127712579178174E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 183 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000183)=0.000000000000000E+00 beta (00000184)=0.134436077312384E+02 gamma(00000184)=0.134436077312384E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 184 z1= 1 -.123257121845610E-06 0.000000000000000E+00 z1= 2 0.186668564891058E-06 0.000000000000000E+00 z1= 3 0.336385737690608E-03 0.000000000000000E+00 alpha(00000184)=0.000000000000000E+00 beta (00000185)=0.131257295418631E+02 gamma(00000185)=0.131257295418631E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 185 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000185)=0.000000000000000E+00 beta (00000186)=0.142025079853729E+02 gamma(00000186)=0.142025079853729E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 186 z1= 1 0.118323796448436E-06 0.000000000000000E+00 z1= 2 -.179635192604352E-06 0.000000000000000E+00 z1= 3 -.393605069685238E-03 0.000000000000000E+00 alpha(00000186)=0.000000000000000E+00 beta (00000187)=0.127865141205151E+02 gamma(00000187)=0.127865141205151E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 187 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000187)=0.000000000000000E+00 beta (00000188)=0.131985042433795E+02 gamma(00000188)=0.131985042433795E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 188 z1= 1 -.119231139704846E-06 0.000000000000000E+00 z1= 2 0.181193292609488E-06 0.000000000000000E+00 z1= 3 0.410919373406503E-03 0.000000000000000E+00 alpha(00000188)=0.000000000000000E+00 beta (00000189)=0.129108667776216E+02 gamma(00000189)=0.129108667776216E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 189 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000189)=0.000000000000000E+00 beta (00000190)=0.141431623649376E+02 gamma(00000190)=0.141431623649376E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 190 z1= 1 0.112001801359356E-06 0.000000000000000E+00 z1= 2 -.170182750047591E-06 0.000000000000000E+00 z1= 3 -.384935338305442E-03 0.000000000000000E+00 alpha(00000190)=0.000000000000000E+00 beta (00000191)=0.126098012838403E+02 gamma(00000191)=0.126098012838403E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 191 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000191)=0.000000000000000E+00 beta (00000192)=0.136884485800250E+02 gamma(00000192)=0.136884485800250E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 192 z1= 1 -.106498209204620E-06 0.000000000000000E+00 z1= 2 0.161996373301398E-06 0.000000000000000E+00 z1= 3 0.333033030801452E-03 0.000000000000000E+00 alpha(00000192)=0.000000000000000E+00 beta (00000193)=0.125495062019491E+02 gamma(00000193)=0.125495062019491E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 193 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000193)=0.000000000000000E+00 beta (00000194)=0.129665715230510E+02 gamma(00000194)=0.129665715230510E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 194 z1= 1 0.105854222956672E-06 0.000000000000000E+00 z1= 2 -.160905146287266E-06 0.000000000000000E+00 z1= 3 -.307305033670172E-03 0.000000000000000E+00 alpha(00000194)=0.000000000000000E+00 beta (00000195)=0.131997625964870E+02 gamma(00000195)=0.131997625964870E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 195 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000195)=0.000000000000000E+00 beta (00000196)=0.138207074696767E+02 gamma(00000196)=0.138207074696767E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 196 z1= 1 -.103494701995537E-06 0.000000000000000E+00 z1= 2 0.157406188964820E-06 0.000000000000000E+00 z1= 3 0.227641811233154E-03 0.000000000000000E+00 alpha(00000196)=0.000000000000000E+00 beta (00000197)=0.133772242222974E+02 gamma(00000197)=0.133772242222974E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 197 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000197)=0.000000000000000E+00 beta (00000198)=0.140061093710338E+02 gamma(00000198)=0.140061093710338E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 198 z1= 1 0.101708405586000E-06 0.000000000000000E+00 z1= 2 -.154357695570035E-06 0.000000000000000E+00 z1= 3 -.649924316004566E-04 0.000000000000000E+00 alpha(00000198)=0.000000000000000E+00 beta (00000199)=0.126385171153054E+02 gamma(00000199)=0.126385171153054E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 199 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000199)=0.000000000000000E+00 beta (00000200)=0.135378052966601E+02 gamma(00000200)=0.135378052966601E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 200 z1= 1 -.991251015467843E-07 0.000000000000000E+00 z1= 2 0.149904496288267E-06 0.000000000000000E+00 z1= 3 -.154761920041029E-03 0.000000000000000E+00 alpha(00000200)=0.000000000000000E+00 beta (00000201)=0.121675482444127E+02 gamma(00000201)=0.121675482444127E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 201 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000201)=0.000000000000000E+00 beta (00000202)=0.137941570435863E+02 gamma(00000202)=0.137941570435863E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 202 z1= 1 0.919419454037526E-07 0.000000000000000E+00 z1= 2 -.138867890360495E-06 0.000000000000000E+00 z1= 3 0.365517963634800E-03 0.000000000000000E+00 alpha(00000202)=0.000000000000000E+00 beta (00000203)=0.128273472578587E+02 gamma(00000203)=0.128273472578587E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 203 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000203)=0.000000000000000E+00 beta (00000204)=0.136965995449007E+02 gamma(00000204)=0.136965995449007E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 204 z1= 1 -.903521510201575E-07 0.000000000000000E+00 z1= 2 0.135803210542414E-06 0.000000000000000E+00 z1= 3 -.554122298899212E-03 0.000000000000000E+00 alpha(00000204)=0.000000000000000E+00 beta (00000205)=0.121520311694188E+02 gamma(00000205)=0.121520311694188E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 205 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000205)=0.000000000000000E+00 beta (00000206)=0.135215311059212E+02 gamma(00000206)=0.135215311059212E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 206 z1= 1 0.858037575725799E-07 0.000000000000000E+00 z1= 2 -.128744200972612E-06 0.000000000000000E+00 z1= 3 0.609021102181202E-03 0.000000000000000E+00 alpha(00000206)=0.000000000000000E+00 beta (00000207)=0.124827257724876E+02 gamma(00000207)=0.124827257724876E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 207 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000207)=0.000000000000000E+00 beta (00000208)=0.134709375753947E+02 gamma(00000208)=0.134709375753947E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 208 z1= 1 -.861989864392497E-07 0.000000000000000E+00 z1= 2 0.129071982804888E-06 0.000000000000000E+00 z1= 3 -.633368799063509E-03 0.000000000000000E+00 alpha(00000208)=0.000000000000000E+00 beta (00000209)=0.123383333686978E+02 gamma(00000209)=0.123383333686978E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 209 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000209)=0.000000000000000E+00 beta (00000210)=0.133462117690822E+02 gamma(00000210)=0.133462117690822E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 210 z1= 1 0.877722942840397E-07 0.000000000000000E+00 z1= 2 -.131187931869586E-06 0.000000000000000E+00 z1= 3 0.710366743950669E-03 0.000000000000000E+00 alpha(00000210)=0.000000000000000E+00 beta (00000211)=0.131432092534998E+02 gamma(00000211)=0.131432092534998E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 211 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000211)=0.000000000000000E+00 beta (00000212)=0.129313044938830E+02 gamma(00000212)=0.129313044938830E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 212 z1= 1 -.962446973621657E-07 0.000000000000000E+00 z1= 2 0.144651396267537E-06 0.000000000000000E+00 z1= 3 -.787560502682839E-03 0.000000000000000E+00 alpha(00000212)=0.000000000000000E+00 beta (00000213)=0.120316612893165E+02 gamma(00000213)=0.120316612893165E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 213 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000213)=0.000000000000000E+00 beta (00000214)=0.134635631913367E+02 gamma(00000214)=0.134635631913367E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 214 z1= 1 0.926065154639765E-07 0.000000000000000E+00 z1= 2 -.140637695033858E-06 0.000000000000000E+00 z1= 3 0.575164280777689E-03 0.000000000000000E+00 alpha(00000214)=0.000000000000000E+00 beta (00000215)=0.127773652963157E+02 gamma(00000215)=0.127773652963157E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 215 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000215)=0.000000000000000E+00 beta (00000216)=0.137654272903637E+02 gamma(00000216)=0.137654272903637E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 216 z1= 1 -.913300970512790E-07 0.000000000000000E+00 z1= 2 0.139181325246450E-06 0.000000000000000E+00 z1= 3 -.157563454897605E-03 0.000000000000000E+00 alpha(00000216)=0.000000000000000E+00 beta (00000217)=0.129434860481632E+02 gamma(00000217)=0.129434860481632E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 217 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000217)=0.000000000000000E+00 beta (00000218)=0.135801760036497E+02 gamma(00000218)=0.135801760036497E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 218 z1= 1 0.919263503367396E-07 0.000000000000000E+00 z1= 2 -.141172032972040E-06 0.000000000000000E+00 z1= 3 -.397901305309534E-03 0.000000000000000E+00 alpha(00000218)=0.000000000000000E+00 beta (00000219)=0.131426399258694E+02 gamma(00000219)=0.131426399258694E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 219 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000219)=0.000000000000000E+00 beta (00000220)=0.139478834765854E+02 gamma(00000220)=0.139478834765854E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 220 z1= 1 -.909947344979048E-07 0.000000000000000E+00 z1= 2 0.140696238646579E-06 0.000000000000000E+00 z1= 3 0.976277917993595E-03 0.000000000000000E+00 alpha(00000220)=0.000000000000000E+00 beta (00000221)=0.131240216142921E+02 gamma(00000221)=0.131240216142921E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 221 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000221)=0.000000000000000E+00 beta (00000222)=0.139778857316854E+02 gamma(00000222)=0.139778857316854E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 222 z1= 1 0.892595076041724E-07 0.000000000000000E+00 z1= 2 -.139121389654073E-06 0.000000000000000E+00 z1= 3 -.144066809304053E-02 0.000000000000000E+00 alpha(00000222)=0.000000000000000E+00 beta (00000223)=0.124280515457386E+02 gamma(00000223)=0.124280515457386E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 223 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000223)=0.000000000000000E+00 beta (00000224)=0.132944039016749E+02 gamma(00000224)=0.132944039016749E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 224 z1= 1 -.881490965469879E-07 0.000000000000000E+00 z1= 2 0.138984503958504E-06 0.000000000000000E+00 z1= 3 0.185286407993232E-02 0.000000000000000E+00 alpha(00000224)=0.000000000000000E+00 beta (00000225)=0.122136750163469E+02 gamma(00000225)=0.122136750163469E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 225 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000225)=0.000000000000000E+00 beta (00000226)=0.138023403035116E+02 gamma(00000226)=0.138023403035116E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 226 z1= 1 0.825467027720187E-07 0.000000000000000E+00 z1= 2 -.130599854143666E-06 0.000000000000000E+00 z1= 3 -.205755240348217E-02 0.000000000000000E+00 alpha(00000226)=0.000000000000000E+00 beta (00000227)=0.128195349196515E+02 gamma(00000227)=0.128195349196515E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 227 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000227)=0.000000000000000E+00 beta (00000228)=0.133703309444056E+02 gamma(00000228)=0.133703309444056E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 228 z1= 1 -.836827045174902E-07 0.000000000000000E+00 z1= 2 0.133785334432718E-06 0.000000000000000E+00 z1= 3 0.232577908647888E-02 0.000000000000000E+00 alpha(00000228)=0.000000000000000E+00 beta (00000229)=0.125924966624578E+02 gamma(00000229)=0.125924966624578E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 229 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000229)=0.000000000000000E+00 beta (00000230)=0.130192223681129E+02 gamma(00000230)=0.130192223681129E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 230 z1= 1 0.851359154942829E-07 0.000000000000000E+00 z1= 2 -.138438638724089E-06 0.000000000000000E+00 z1= 3 -.254072656132575E-02 0.000000000000000E+00 alpha(00000230)=0.000000000000000E+00 beta (00000231)=0.127333219192121E+02 gamma(00000231)=0.127333219192121E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 231 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000231)=0.000000000000000E+00 beta (00000232)=0.139348355249269E+02 gamma(00000232)=0.139348355249269E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 232 z1= 1 -.805680839052877E-07 0.000000000000000E+00 z1= 2 0.133031938189324E-06 0.000000000000000E+00 z1= 3 0.246908111708025E-02 0.000000000000000E+00 alpha(00000232)=0.000000000000000E+00 beta (00000233)=0.130952335314932E+02 gamma(00000233)=0.130952335314932E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 233 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000233)=0.000000000000000E+00 beta (00000234)=0.137083000610831E+02 gamma(00000234)=0.137083000610831E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 234 z1= 1 0.789324904967468E-07 0.000000000000000E+00 z1= 2 -.132775017573519E-06 0.000000000000000E+00 z1= 3 -.244723282951635E-02 0.000000000000000E+00 alpha(00000234)=0.000000000000000E+00 beta (00000235)=0.130599272477669E+02 gamma(00000235)=0.130599272477669E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 235 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000235)=0.000000000000000E+00 beta (00000236)=0.137365061045795E+02 gamma(00000236)=0.137365061045795E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 236 z1= 1 -.767141396026006E-07 0.000000000000000E+00 z1= 2 0.131943979830856E-06 0.000000000000000E+00 z1= 3 0.235350497396065E-02 0.000000000000000E+00 alpha(00000236)=0.000000000000000E+00 beta (00000237)=0.129746608935082E+02 gamma(00000237)=0.129746608935082E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 237 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000237)=0.000000000000000E+00 beta (00000238)=0.134991672127711E+02 gamma(00000238)=0.134991672127711E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 238 z1= 1 0.757600856130902E-07 0.000000000000000E+00 z1= 2 -.134176547683993E-06 0.000000000000000E+00 z1= 3 -.221079047725112E-02 0.000000000000000E+00 alpha(00000238)=0.000000000000000E+00 beta (00000239)=0.128953549855207E+02 gamma(00000239)=0.128953549855207E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 239 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000239)=0.000000000000000E+00 beta (00000240)=0.140822844231566E+02 gamma(00000240)=0.140822844231566E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 240 z1= 1 -.709337606156270E-07 0.000000000000000E+00 z1= 2 0.128861361244385E-06 0.000000000000000E+00 z1= 3 0.197405592537963E-02 0.000000000000000E+00 alpha(00000240)=0.000000000000000E+00 beta (00000241)=0.127853604741539E+02 gamma(00000241)=0.127853604741539E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 241 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000241)=0.000000000000000E+00 beta (00000242)=0.137913028588998E+02 gamma(00000242)=0.137913028588998E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 242 z1= 1 0.668782973738038E-07 0.000000000000000E+00 z1= 2 -.123887809588960E-06 0.000000000000000E+00 z1= 3 -.177465265371094E-02 0.000000000000000E+00 alpha(00000242)=0.000000000000000E+00 beta (00000243)=0.128796897964059E+02 gamma(00000243)=0.128796897964059E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 243 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000243)=0.000000000000000E+00 beta (00000244)=0.129163212759011E+02 gamma(00000244)=0.129163212759011E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 244 z1= 1 -.680345315236773E-07 0.000000000000000E+00 z1= 2 0.128737254224314E-06 0.000000000000000E+00 z1= 3 0.173031655998228E-02 0.000000000000000E+00 alpha(00000244)=0.000000000000000E+00 beta (00000245)=0.122324389069311E+02 gamma(00000245)=0.122324389069311E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 245 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000245)=0.000000000000000E+00 beta (00000246)=0.134038470878867E+02 gamma(00000246)=0.134038470878867E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 246 z1= 1 0.629806714113734E-07 0.000000000000000E+00 z1= 2 -.121060500491614E-06 0.000000000000000E+00 z1= 3 -.154099713934922E-02 0.000000000000000E+00 alpha(00000246)=0.000000000000000E+00 beta (00000247)=0.122777851385216E+02 gamma(00000247)=0.122777851385216E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 247 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000247)=0.000000000000000E+00 beta (00000248)=0.135848181692524E+02 gamma(00000248)=0.135848181692524E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 248 z1= 1 -.574420331736578E-07 0.000000000000000E+00 z1= 2 0.111617934747113E-06 0.000000000000000E+00 z1= 3 0.141999431715967E-02 0.000000000000000E+00 alpha(00000248)=0.000000000000000E+00 beta (00000249)=0.130687275514209E+02 gamma(00000249)=0.130687275514209E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 249 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000249)=0.000000000000000E+00 beta (00000250)=0.134102293237834E+02 gamma(00000250)=0.134102293237834E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 250 z1= 1 0.570478100965152E-07 0.000000000000000E+00 z1= 2 -.111902910330934E-06 0.000000000000000E+00 z1= 3 -.143103560270077E-02 0.000000000000000E+00 alpha(00000250)=0.000000000000000E+00 beta (00000251)=0.126421977346349E+02 gamma(00000251)=0.126421977346349E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 251 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000251)=0.000000000000000E+00 beta (00000252)=0.137096212031123E+02 gamma(00000252)=0.137096212031123E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 252 z1= 1 -.532766783786342E-07 0.000000000000000E+00 z1= 2 0.104051763035167E-06 0.000000000000000E+00 z1= 3 0.145223127264751E-02 0.000000000000000E+00 alpha(00000252)=0.000000000000000E+00 beta (00000253)=0.128989863896697E+02 gamma(00000253)=0.128989863896697E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 253 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000253)=0.000000000000000E+00 beta (00000254)=0.133010389433021E+02 gamma(00000254)=0.133010389433021E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 254 z1= 1 0.528926907595890E-07 0.000000000000000E+00 z1= 2 -.102022323081948E-06 0.000000000000000E+00 z1= 3 -.156835745509749E-02 0.000000000000000E+00 alpha(00000254)=0.000000000000000E+00 beta (00000255)=0.122325708408919E+02 gamma(00000255)=0.122325708408919E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 255 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000255)=0.000000000000000E+00 beta (00000256)=0.143760064511071E+02 gamma(00000256)=0.143760064511071E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 256 z1= 1 -.467255567078873E-07 0.000000000000000E+00 z1= 2 0.891219463279190E-07 0.000000000000000E+00 z1= 3 0.149817425058418E-02 0.000000000000000E+00 alpha(00000256)=0.000000000000000E+00 beta (00000257)=0.124168905153509E+02 gamma(00000257)=0.124168905153509E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 257 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000257)=0.000000000000000E+00 beta (00000258)=0.133196410362137E+02 gamma(00000258)=0.133196410362137E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 258 z1= 1 0.449901687682008E-07 0.000000000000000E+00 z1= 2 -.836308030923837E-07 0.000000000000000E+00 z1= 3 -.168682813253128E-02 0.000000000000000E+00 alpha(00000258)=0.000000000000000E+00 beta (00000259)=0.127162337460491E+02 gamma(00000259)=0.127162337460491E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 259 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000259)=0.000000000000000E+00 beta (00000260)=0.136365128573416E+02 gamma(00000260)=0.136365128573416E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 260 z1= 1 -.446491745633771E-07 0.000000000000000E+00 z1= 2 0.797806582809629E-07 0.000000000000000E+00 z1= 3 0.192722888420793E-02 0.000000000000000E+00 alpha(00000260)=0.000000000000000E+00 beta (00000261)=0.125281258229015E+02 gamma(00000261)=0.125281258229015E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 261 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000261)=0.000000000000000E+00 beta (00000262)=0.137293773045728E+02 gamma(00000262)=0.137293773045728E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 262 z1= 1 0.434073138722187E-07 0.000000000000000E+00 z1= 2 -.743691476487820E-07 0.000000000000000E+00 z1= 3 -.213380604033549E-02 0.000000000000000E+00 alpha(00000262)=0.000000000000000E+00 beta (00000263)=0.128310533107097E+02 gamma(00000263)=0.128310533107097E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 263 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000263)=0.000000000000000E+00 beta (00000264)=0.133327075659136E+02 gamma(00000264)=0.133327075659136E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 264 z1= 1 -.432760185774868E-07 0.000000000000000E+00 z1= 2 0.721576580718685E-07 0.000000000000000E+00 z1= 3 0.233273799622333E-02 0.000000000000000E+00 alpha(00000264)=0.000000000000000E+00 beta (00000265)=0.131090116568814E+02 gamma(00000265)=0.131090116568814E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 265 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000265)=0.000000000000000E+00 beta (00000266)=0.135958559984044E+02 gamma(00000266)=0.135958559984044E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 266 z1= 1 0.436851597608763E-07 0.000000000000000E+00 z1= 2 -.712096588778577E-07 0.000000000000000E+00 z1= 3 -.240893492567521E-02 0.000000000000000E+00 alpha(00000266)=0.000000000000000E+00 beta (00000267)=0.129880415180152E+02 gamma(00000267)=0.129880415180152E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 267 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000267)=0.000000000000000E+00 beta (00000268)=0.133629508797574E+02 gamma(00000268)=0.133629508797574E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 268 z1= 1 -.443310139147798E-07 0.000000000000000E+00 z1= 2 0.701525373049622E-07 0.000000000000000E+00 z1= 3 0.257425190712084E-02 0.000000000000000E+00 alpha(00000268)=0.000000000000000E+00 beta (00000269)=0.121759126219050E+02 gamma(00000269)=0.121759126219050E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 269 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000269)=0.000000000000000E+00 beta (00000270)=0.135466237234059E+02 gamma(00000270)=0.135466237234059E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 270 z1= 1 0.424811778278449E-07 0.000000000000000E+00 z1= 2 -.650423558792683E-07 0.000000000000000E+00 z1= 3 -.255263252541608E-02 0.000000000000000E+00 alpha(00000270)=0.000000000000000E+00 beta (00000271)=0.125732345015802E+02 gamma(00000271)=0.125732345015802E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 271 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000271)=0.000000000000000E+00 beta (00000272)=0.138866552037453E+02 gamma(00000272)=0.138866552037453E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 272 z1= 1 -.406891279424067E-07 0.000000000000000E+00 z1= 2 0.615331660719321E-07 0.000000000000000E+00 z1= 3 0.249896000232668E-02 0.000000000000000E+00 alpha(00000272)=0.000000000000000E+00 beta (00000273)=0.127527359105673E+02 gamma(00000273)=0.127527359105673E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 273 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000273)=0.000000000000000E+00 beta (00000274)=0.137255328512341E+02 gamma(00000274)=0.137255328512341E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 274 z1= 1 0.390433208704005E-07 0.000000000000000E+00 z1= 2 -.588211011314692E-07 0.000000000000000E+00 z1= 3 -.243685221609056E-02 0.000000000000000E+00 alpha(00000274)=0.000000000000000E+00 beta (00000275)=0.130992328600151E+02 gamma(00000275)=0.130992328600151E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 275 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000275)=0.000000000000000E+00 beta (00000276)=0.133642785011130E+02 gamma(00000276)=0.133642785011130E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 276 z1= 1 -.402481491425168E-07 0.000000000000000E+00 z1= 2 0.605898939568927E-07 0.000000000000000E+00 z1= 3 0.253195028202389E-02 0.000000000000000E+00 alpha(00000276)=0.000000000000000E+00 beta (00000277)=0.121173650312641E+02 gamma(00000277)=0.121173650312641E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 277 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000277)=0.000000000000000E+00 beta (00000278)=0.139902176142667E+02 gamma(00000278)=0.139902176142667E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 278 z1= 1 0.380517714366406E-07 0.000000000000000E+00 z1= 2 -.577412509838006E-07 0.000000000000000E+00 z1= 3 -.234372689885304E-02 0.000000000000000E+00 alpha(00000278)=0.000000000000000E+00 beta (00000279)=0.128103187533245E+02 gamma(00000279)=0.128103187533245E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 279 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000279)=0.000000000000000E+00 beta (00000280)=0.132105606333985E+02 gamma(00000280)=0.132105606333985E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 280 z1= 1 -.397967693790621E-07 0.000000000000000E+00 z1= 2 0.610558310097219E-07 0.000000000000000E+00 z1= 3 0.242949963128463E-02 0.000000000000000E+00 alpha(00000280)=0.000000000000000E+00 beta (00000281)=0.125789411109652E+02 gamma(00000281)=0.125789411109652E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 281 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000281)=0.000000000000000E+00 beta (00000282)=0.131349887663953E+02 gamma(00000282)=0.131349887663953E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 282 z1= 1 0.406004318170925E-07 0.000000000000000E+00 z1= 2 -.633119769277062E-07 0.000000000000000E+00 z1= 3 -.246823083387489E-02 0.000000000000000E+00 alpha(00000282)=0.000000000000000E+00 beta (00000283)=0.131792472622707E+02 gamma(00000283)=0.131792472622707E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 283 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000283)=0.000000000000000E+00 beta (00000284)=0.143606181229174E+02 gamma(00000284)=0.143606181229174E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 284 z1= 1 -.381440791208691E-07 0.000000000000000E+00 z1= 2 0.617041991043954E-07 0.000000000000000E+00 z1= 3 0.240360055977428E-02 0.000000000000000E+00 alpha(00000284)=0.000000000000000E+00 beta (00000285)=0.126008236282100E+02 gamma(00000285)=0.126008236282100E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 285 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000285)=0.000000000000000E+00 beta (00000286)=0.132861158655485E+02 gamma(00000286)=0.132861158655485E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 286 z1= 1 0.363661759021790E-07 0.000000000000000E+00 z1= 2 -.614396075137875E-07 0.000000000000000E+00 z1= 3 -.242914199376765E-02 0.000000000000000E+00 alpha(00000286)=0.000000000000000E+00 beta (00000287)=0.120640819168975E+02 gamma(00000287)=0.120640819168975E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 287 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000287)=0.000000000000000E+00 beta (00000288)=0.138125628546352E+02 gamma(00000288)=0.138125628546352E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 288 z1= 1 -.324632441177234E-07 0.000000000000000E+00 z1= 2 0.579131013587683E-07 0.000000000000000E+00 z1= 3 0.233246306471475E-02 0.000000000000000E+00 alpha(00000288)=0.000000000000000E+00 beta (00000289)=0.129650542587149E+02 gamma(00000289)=0.129650542587149E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 289 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000289)=0.000000000000000E+00 beta (00000290)=0.130428501439781E+02 gamma(00000290)=0.130428501439781E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 290 z1= 1 0.331376652350918E-07 0.000000000000000E+00 z1= 2 -.630783232255798E-07 0.000000000000000E+00 z1= 3 -.246434613607625E-02 0.000000000000000E+00 alpha(00000290)=0.000000000000000E+00 beta (00000291)=0.125821339086290E+02 gamma(00000291)=0.125821339086290E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 291 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000291)=0.000000000000000E+00 beta (00000292)=0.143053319305114E+02 gamma(00000292)=0.143053319305114E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 292 z1= 1 -.292913180405686E-07 0.000000000000000E+00 z1= 2 0.595259188825611E-07 0.000000000000000E+00 z1= 3 0.226391431644802E-02 0.000000000000000E+00 alpha(00000292)=0.000000000000000E+00 beta (00000293)=0.125510203497072E+02 gamma(00000293)=0.125510203497072E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 293 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000293)=0.000000000000000E+00 beta (00000294)=0.129608033802207E+02 gamma(00000294)=0.129608033802207E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 294 z1= 1 0.288073350781376E-07 0.000000000000000E+00 z1= 2 -.618796360267633E-07 0.000000000000000E+00 z1= 3 -.220778051189528E-02 0.000000000000000E+00 alpha(00000294)=0.000000000000000E+00 beta (00000295)=0.125943750702874E+02 gamma(00000295)=0.125943750702874E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 295 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000295)=0.000000000000000E+00 beta (00000296)=0.131301376630553E+02 gamma(00000296)=0.131301376630553E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 296 z1= 1 -.284630588297859E-07 0.000000000000000E+00 z1= 2 0.631383199984833E-07 0.000000000000000E+00 z1= 3 0.214126123335250E-02 0.000000000000000E+00 alpha(00000296)=0.000000000000000E+00 beta (00000297)=0.129641706411223E+02 gamma(00000297)=0.129641706411223E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 297 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000297)=0.000000000000000E+00 beta (00000298)=0.139126983728827E+02 gamma(00000298)=0.139126983728827E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 298 z1= 1 0.272829164093668E-07 0.000000000000000E+00 z1= 2 -.620770873895320E-07 0.000000000000000E+00 z1= 3 -.209145819553573E-02 0.000000000000000E+00 alpha(00000298)=0.000000000000000E+00 beta (00000299)=0.122084669876661E+02 gamma(00000299)=0.122084669876661E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 299 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000299)=0.000000000000000E+00 beta (00000300)=0.141340081301755E+02 gamma(00000300)=0.141340081301755E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 300 z1= 1 -.236244605419066E-07 0.000000000000000E+00 z1= 2 0.557203902164455E-07 0.000000000000000E+00 z1= 3 0.201351026215087E-02 0.000000000000000E+00 alpha(00000300)=0.000000000000000E+00 beta (00000301)=0.124095629377479E+02 gamma(00000301)=0.124095629377479E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 301 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000301)=0.000000000000000E+00 beta (00000302)=0.132823729013962E+02 gamma(00000302)=0.132823729013962E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 302 z1= 1 0.213250481946375E-07 0.000000000000000E+00 z1= 2 -.529627219245923E-07 0.000000000000000E+00 z1= 3 -.206792202638477E-02 0.000000000000000E+00 alpha(00000302)=0.000000000000000E+00 beta (00000303)=0.123622914190321E+02 gamma(00000303)=0.123622914190321E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 303 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000303)=0.000000000000000E+00 beta (00000304)=0.140351287719193E+02 gamma(00000304)=0.140351287719193E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 304 z1= 1 -.176591200303075E-07 0.000000000000000E+00 z1= 2 0.481571136515127E-07 0.000000000000000E+00 z1= 3 0.189065945837885E-02 0.000000000000000E+00 alpha(00000304)=0.000000000000000E+00 beta (00000305)=0.128013819701543E+02 gamma(00000305)=0.128013819701543E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 305 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000305)=0.000000000000000E+00 beta (00000306)=0.138031973925848E+02 gamma(00000306)=0.138031973925848E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 306 z1= 1 0.154433717845098E-07 0.000000000000000E+00 z1= 2 -.461466518066034E-07 0.000000000000000E+00 z1= 3 -.183307435840798E-02 0.000000000000000E+00 alpha(00000306)=0.000000000000000E+00 beta (00000307)=0.131487635907683E+02 gamma(00000307)=0.131487635907683E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 307 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000307)=0.000000000000000E+00 beta (00000308)=0.136626246728972E+02 gamma(00000308)=0.136626246728972E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 308 z1= 1 -.143151181205116E-07 0.000000000000000E+00 z1= 2 0.458584378604590E-07 0.000000000000000E+00 z1= 3 0.183638568600381E-02 0.000000000000000E+00 alpha(00000308)=0.000000000000000E+00 beta (00000309)=0.133364497678505E+02 gamma(00000309)=0.133364497678505E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 309 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000309)=0.000000000000000E+00 beta (00000310)=0.134467911295657E+02 gamma(00000310)=0.134467911295657E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 310 z1= 1 0.136203285144550E-07 0.000000000000000E+00 z1= 2 -.451542221301874E-07 0.000000000000000E+00 z1= 3 -.184677173119321E-02 0.000000000000000E+00 alpha(00000310)=0.000000000000000E+00 beta (00000311)=0.126213677281651E+02 gamma(00000311)=0.126213677281651E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 311 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000311)=0.000000000000000E+00 beta (00000312)=0.132169189785825E+02 gamma(00000312)=0.132169189785825E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 312 z1= 1 -.112584640404910E-07 0.000000000000000E+00 z1= 2 0.418341365409757E-07 0.000000000000000E+00 z1= 3 0.169540089933280E-02 0.000000000000000E+00 alpha(00000312)=0.000000000000000E+00 beta (00000313)=0.121996673699553E+02 gamma(00000313)=0.121996673699553E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 313 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000313)=0.000000000000000E+00 beta (00000314)=0.135052587955959E+02 gamma(00000314)=0.135052587955959E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 314 z1= 1 0.885404267503102E-08 0.000000000000000E+00 z1= 2 -.381371185682921E-07 0.000000000000000E+00 z1= 3 -.137765892958172E-02 0.000000000000000E+00 alpha(00000314)=0.000000000000000E+00 beta (00000315)=0.126523648225567E+02 gamma(00000315)=0.126523648225567E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 315 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000315)=0.000000000000000E+00 beta (00000316)=0.137217430294256E+02 gamma(00000316)=0.137217430294256E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 316 z1= 1 -.613084398580575E-08 0.000000000000000E+00 z1= 2 0.348549107716169E-07 0.000000000000000E+00 z1= 3 0.100895365103597E-02 0.000000000000000E+00 alpha(00000316)=0.000000000000000E+00 beta (00000317)=0.117596642389363E+02 gamma(00000317)=0.117596642389363E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 317 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000317)=0.000000000000000E+00 beta (00000318)=0.140148381423131E+02 gamma(00000318)=0.140148381423131E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 318 z1= 1 0.274817744328935E-08 0.000000000000000E+00 z1= 2 -.265751452335522E-07 0.000000000000000E+00 z1= 3 -.438486902531128E-03 0.000000000000000E+00 alpha(00000318)=0.000000000000000E+00 beta (00000319)=0.132456522011096E+02 gamma(00000319)=0.132456522011096E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 319 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000319)=0.000000000000000E+00 beta (00000320)=0.141415959297863E+02 gamma(00000320)=0.141415959297863E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 320 z1= 1 -.388505326325526E-09 0.000000000000000E+00 z1= 2 0.231101160696199E-07 0.000000000000000E+00 z1= 3 0.383385958662094E-04 0.000000000000000E+00 alpha(00000320)=0.000000000000000E+00 beta (00000321)=0.121338994897937E+02 gamma(00000321)=0.121338994897937E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 321 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000321)=0.000000000000000E+00 beta (00000322)=0.139422992727482E+02 gamma(00000322)=0.139422992727482E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 322 z1= 1 0.300934650517091E-09 0.000000000000000E+00 z1= 2 -.195659609943252E-07 0.000000000000000E+00 z1= 3 0.322278143598923E-03 0.000000000000000E+00 alpha(00000322)=0.000000000000000E+00 beta (00000323)=0.124488270804086E+02 gamma(00000323)=0.124488270804086E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 323 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000323)=0.000000000000000E+00 beta (00000324)=0.144224763398852E+02 gamma(00000324)=0.144224763398852E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 324 z1= 1 -.281573757907917E-09 0.000000000000000E+00 z1= 2 0.180270177372081E-07 0.000000000000000E+00 z1= 3 -.511780773780425E-03 0.000000000000000E+00 alpha(00000324)=0.000000000000000E+00 beta (00000325)=0.132381347631503E+02 gamma(00000325)=0.132381347631503E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 325 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000325)=0.000000000000000E+00 beta (00000326)=0.141725208779039E+02 gamma(00000326)=0.141725208779039E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 326 z1= 1 0.157424979841769E-08 0.000000000000000E+00 z1= 2 -.180189626168082E-07 0.000000000000000E+00 z1= 3 0.542179860335071E-03 0.000000000000000E+00 alpha(00000326)=0.000000000000000E+00 beta (00000327)=0.125444288658313E+02 gamma(00000327)=0.125444288658313E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 327 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000327)=0.000000000000000E+00 beta (00000328)=0.132169814114763E+02 gamma(00000328)=0.132169814114763E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 328 z1= 1 -.201634171799513E-08 0.000000000000000E+00 z1= 2 0.172042918604703E-07 0.000000000000000E+00 z1= 3 -.433132521823064E-03 0.000000000000000E+00 alpha(00000328)=0.000000000000000E+00 beta (00000329)=0.130751330328190E+02 gamma(00000329)=0.130751330328190E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 329 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000329)=0.000000000000000E+00 beta (00000330)=0.139827616233659E+02 gamma(00000330)=0.139827616233659E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 330 z1= 1 0.186026738246492E-08 0.000000000000000E+00 z1= 2 -.145862067030831E-07 0.000000000000000E+00 z1= 3 0.288031909523564E-03 0.000000000000000E+00 alpha(00000330)=0.000000000000000E+00 beta (00000331)=0.121246575654359E+02 gamma(00000331)=0.121246575654359E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 331 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000331)=0.000000000000000E+00 beta (00000332)=0.138168519609541E+02 gamma(00000332)=0.138168519609541E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 332 z1= 1 -.785981329689709E-09 0.000000000000000E+00 z1= 2 0.129295433570265E-07 0.000000000000000E+00 z1= 3 -.159427887177048E-03 0.000000000000000E+00 alpha(00000332)=0.000000000000000E+00 beta (00000333)=0.124291734440917E+02 gamma(00000333)=0.124291734440917E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 333 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000333)=0.000000000000000E+00 beta (00000334)=0.130602273911139E+02 gamma(00000334)=0.130602273911139E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 334 z1= 1 -.783058796990465E-09 0.000000000000000E+00 z1= 2 -.123145719713760E-07 0.000000000000000E+00 z1= 3 0.835381015787846E-04 0.000000000000000E+00 alpha(00000334)=0.000000000000000E+00 beta (00000335)=0.128787136465810E+02 gamma(00000335)=0.128787136465810E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 335 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000335)=0.000000000000000E+00 beta (00000336)=0.129322969558746E+02 gamma(00000336)=0.129322969558746E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 336 z1= 1 0.246210228996345E-08 0.000000000000000E+00 z1= 2 0.117713804406125E-07 0.000000000000000E+00 z1= 3 -.120370959183021E-03 0.000000000000000E+00 alpha(00000336)=0.000000000000000E+00 beta (00000337)=0.127434650560988E+02 gamma(00000337)=0.127434650560988E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 337 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000337)=0.000000000000000E+00 beta (00000338)=0.125328866861458E+02 gamma(00000338)=0.125328866861458E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 338 z1= 1 -.344733501015943E-08 0.000000000000000E+00 z1= 2 -.135235562243903E-07 0.000000000000000E+00 z1= 3 0.249262554450003E-03 0.000000000000000E+00 alpha(00000338)=0.000000000000000E+00 beta (00000339)=0.139092205163725E+02 gamma(00000339)=0.139092205163725E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 339 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000339)=0.000000000000000E+00 beta (00000340)=0.135478330834414E+02 gamma(00000340)=0.135478330834414E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 340 z1= 1 0.468367904676799E-08 0.000000000000000E+00 z1= 2 0.135230575467022E-07 0.000000000000000E+00 z1= 3 -.386162149789166E-03 0.000000000000000E+00 alpha(00000340)=0.000000000000000E+00 beta (00000341)=0.122812098649824E+02 gamma(00000341)=0.122812098649824E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 341 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000341)=0.000000000000000E+00 beta (00000342)=0.139599401785359E+02 gamma(00000342)=0.139599401785359E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 342 z1= 1 -.678775650535482E-08 0.000000000000000E+00 z1= 2 -.120892900972133E-07 0.000000000000000E+00 z1= 3 0.549226299533464E-03 0.000000000000000E+00 alpha(00000342)=0.000000000000000E+00 beta (00000343)=0.127235780376219E+02 gamma(00000343)=0.127235780376219E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 343 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000343)=0.000000000000000E+00 beta (00000344)=0.137564718882381E+02 gamma(00000344)=0.137564718882381E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 344 z1= 1 0.747383872841498E-08 0.000000000000000E+00 z1= 2 0.980943734555781E-08 0.000000000000000E+00 z1= 3 -.782077651585306E-03 0.000000000000000E+00 alpha(00000344)=0.000000000000000E+00 beta (00000345)=0.123641186058267E+02 gamma(00000345)=0.123641186058267E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 345 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000345)=0.000000000000000E+00 beta (00000346)=0.142142314808204E+02 gamma(00000346)=0.142142314808204E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 346 z1= 1 -.860222824037042E-08 0.000000000000000E+00 z1= 2 -.104250646638140E-07 0.000000000000000E+00 z1= 3 0.909074563279915E-03 0.000000000000000E+00 alpha(00000346)=0.000000000000000E+00 beta (00000347)=0.124948812460292E+02 gamma(00000347)=0.124948812460292E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 347 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000347)=0.000000000000000E+00 beta (00000348)=0.146114936289328E+02 gamma(00000348)=0.146114936289328E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 348 z1= 1 0.788178933553460E-08 0.000000000000000E+00 z1= 2 0.840759518124336E-08 0.000000000000000E+00 z1= 3 -.107332767884970E-02 0.000000000000000E+00 alpha(00000348)=0.000000000000000E+00 beta (00000349)=0.121762506263409E+02 gamma(00000349)=0.121762506263409E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 349 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000349)=0.000000000000000E+00 beta (00000350)=0.129204832377495E+02 gamma(00000350)=0.129204832377495E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 350 z1= 1 -.116785331711754E-07 0.000000000000000E+00 z1= 2 -.595752932295928E-08 0.000000000000000E+00 z1= 3 0.137533401139908E-02 0.000000000000000E+00 alpha(00000350)=0.000000000000000E+00 beta (00000351)=0.128670959833501E+02 gamma(00000351)=0.128670959833501E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 351 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000351)=0.000000000000000E+00 beta (00000352)=0.140455026546371E+02 gamma(00000352)=0.140455026546371E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 352 z1= 1 0.120606268310286E-07 0.000000000000000E+00 z1= 2 0.228629639685888E-08 0.000000000000000E+00 z1= 3 -.146322376255223E-02 0.000000000000000E+00 alpha(00000352)=0.000000000000000E+00 beta (00000353)=0.125004042789996E+02 gamma(00000353)=0.125004042789996E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 353 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000353)=0.000000000000000E+00 beta (00000354)=0.134582301167085E+02 gamma(00000354)=0.134582301167085E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 354 z1= 1 -.161481297457008E-07 0.000000000000000E+00 z1= 2 0.126436209947427E-08 0.000000000000000E+00 z1= 3 0.147929461474804E-02 0.000000000000000E+00 alpha(00000354)=0.000000000000000E+00 beta (00000355)=0.125144620839498E+02 gamma(00000355)=0.125144620839498E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 355 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000355)=0.000000000000000E+00 beta (00000356)=0.133937523663182E+02 gamma(00000356)=0.133937523663182E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 356 z1= 1 0.153729919774928E-07 0.000000000000000E+00 z1= 2 -.696201315434491E-08 0.000000000000000E+00 z1= 3 -.146107289749246E-02 0.000000000000000E+00 alpha(00000356)=0.000000000000000E+00 beta (00000357)=0.123723923502276E+02 gamma(00000357)=0.123723923502276E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 357 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000357)=0.000000000000000E+00 beta (00000358)=0.137873383053514E+02 gamma(00000358)=0.137873383053514E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 358 z1= 1 -.172606088299230E-07 0.000000000000000E+00 z1= 2 0.740011740036836E-08 0.000000000000000E+00 z1= 3 0.124279269382972E-02 0.000000000000000E+00 alpha(00000358)=0.000000000000000E+00 beta (00000359)=0.125468377960932E+02 gamma(00000359)=0.125468377960932E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 359 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000359)=0.000000000000000E+00 beta (00000360)=0.137236977653948E+02 gamma(00000360)=0.137236977653948E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 360 z1= 1 0.143851666931398E-07 0.000000000000000E+00 z1= 2 -.148447956054899E-07 0.000000000000000E+00 z1= 3 -.880786928917123E-03 0.000000000000000E+00 alpha(00000360)=0.000000000000000E+00 beta (00000361)=0.124991158958939E+02 gamma(00000361)=0.124991158958939E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 361 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000361)=0.000000000000000E+00 beta (00000362)=0.132496931452503E+02 gamma(00000362)=0.132496931452503E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 362 z1= 1 -.204372074284536E-07 0.000000000000000E+00 z1= 2 0.169880038870449E-07 0.000000000000000E+00 z1= 3 0.402910338129288E-03 0.000000000000000E+00 alpha(00000362)=0.000000000000000E+00 beta (00000363)=0.127069222335333E+02 gamma(00000363)=0.127069222335333E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 363 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000363)=0.000000000000000E+00 beta (00000364)=0.139580145252977E+02 gamma(00000364)=0.139580145252977E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 364 z1= 1 0.145562431035019E-07 0.000000000000000E+00 z1= 2 -.265634942257570E-07 0.000000000000000E+00 z1= 3 0.210728878338087E-03 0.000000000000000E+00 alpha(00000364)=0.000000000000000E+00 beta (00000365)=0.130239904835405E+02 gamma(00000365)=0.130239904835405E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 365 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000365)=0.000000000000000E+00 beta (00000366)=0.131039296406859E+02 gamma(00000366)=0.131039296406859E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 366 z1= 1 -.240750237888291E-07 0.000000000000000E+00 z1= 2 0.271306594244063E-07 0.000000000000000E+00 z1= 3 -.751914589341471E-03 0.000000000000000E+00 alpha(00000366)=0.000000000000000E+00 beta (00000367)=0.127858063588661E+02 gamma(00000367)=0.127858063588661E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 367 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000367)=0.000000000000000E+00 beta (00000368)=0.130555041069354E+02 gamma(00000368)=0.130555041069354E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 368 z1= 1 0.154926793273676E-07 0.000000000000000E+00 z1= 2 -.411029183969443E-07 0.000000000000000E+00 z1= 3 0.119979151154262E-02 0.000000000000000E+00 alpha(00000368)=0.000000000000000E+00 beta (00000369)=0.124418598510054E+02 gamma(00000369)=0.124418598510054E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 369 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000369)=0.000000000000000E+00 beta (00000370)=0.138364623672880E+02 gamma(00000370)=0.138364623672880E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 370 z1= 1 -.293809830166961E-07 0.000000000000000E+00 z1= 2 0.342190221359786E-07 0.000000000000000E+00 z1= 3 -.146548009860390E-02 0.000000000000000E+00 alpha(00000370)=0.000000000000000E+00 beta (00000371)=0.124646130965244E+02 gamma(00000371)=0.124646130965244E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 371 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000371)=0.000000000000000E+00 beta (00000372)=0.136421948441187E+02 gamma(00000372)=0.136421948441187E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 372 z1= 1 0.107076527192411E-07 0.000000000000000E+00 z1= 2 -.505611902910431E-07 0.000000000000000E+00 z1= 3 0.165011114804518E-02 0.000000000000000E+00 alpha(00000372)=0.000000000000000E+00 beta (00000373)=0.126376748456831E+02 gamma(00000373)=0.126376748456831E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 373 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000373)=0.000000000000000E+00 beta (00000374)=0.138225500342586E+02 gamma(00000374)=0.138225500342586E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 374 z1= 1 -.374853049581528E-07 0.000000000000000E+00 z1= 2 0.346312354766428E-07 0.000000000000000E+00 z1= 3 -.190561500122782E-02 0.000000000000000E+00 alpha(00000374)=0.000000000000000E+00 beta (00000375)=0.133429177140778E+02 gamma(00000375)=0.133429177140778E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 375 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000375)=0.000000000000000E+00 beta (00000376)=0.137210130008295E+02 gamma(00000376)=0.137210130008295E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 376 z1= 1 0.103151948383775E-07 0.000000000000000E+00 z1= 2 -.617015497006413E-07 0.000000000000000E+00 z1= 3 0.222379658429525E-02 0.000000000000000E+00 alpha(00000376)=0.000000000000000E+00 beta (00000377)=0.124942881709082E+02 gamma(00000377)=0.124942881709082E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 377 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000377)=0.000000000000000E+00 beta (00000378)=0.140818541046541E+02 gamma(00000378)=0.140818541046541E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 378 z1= 1 -.408448197952629E-07 0.000000000000000E+00 z1= 2 0.366981104328763E-07 0.000000000000000E+00 z1= 3 -.215289255195894E-02 0.000000000000000E+00 alpha(00000378)=0.000000000000000E+00 beta (00000379)=0.123121542914002E+02 gamma(00000379)=0.123121542914002E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 379 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000379)=0.000000000000000E+00 beta (00000380)=0.132017054353982E+02 gamma(00000380)=0.132017054353982E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 380 z1= 1 0.629022142532853E-08 0.000000000000000E+00 z1= 2 -.603756596320596E-07 0.000000000000000E+00 z1= 3 0.202186104921429E-02 0.000000000000000E+00 alpha(00000380)=0.000000000000000E+00 beta (00000381)=0.127248121530031E+02 gamma(00000381)=0.127248121530031E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 381 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000381)=0.000000000000000E+00 beta (00000382)=0.136075634896537E+02 gamma(00000382)=0.136075634896537E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 382 z1= 1 -.439014146122506E-07 0.000000000000000E+00 z1= 2 0.286139450589697E-07 0.000000000000000E+00 z1= 3 -.166975510819998E-02 0.000000000000000E+00 alpha(00000382)=0.000000000000000E+00 beta (00000383)=0.137015355413143E+02 gamma(00000383)=0.137015355413143E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 383 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000383)=0.000000000000000E+00 beta (00000384)=0.129608979646140E+02 gamma(00000384)=0.129608979646140E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 384 z1= 1 0.262522443128695E-09 0.000000000000000E+00 z1= 2 -.640846947354691E-07 0.000000000000000E+00 z1= 3 0.145784290111351E-02 0.000000000000000E+00 alpha(00000384)=0.000000000000000E+00 beta (00000385)=0.122923696613665E+02 gamma(00000385)=0.122923696613665E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 385 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000385)=0.000000000000000E+00 beta (00000386)=0.143301126136826E+02 gamma(00000386)=0.143301126136826E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 386 z1= 1 -.459370895750490E-07 0.000000000000000E+00 z1= 2 0.200647848485908E-07 0.000000000000000E+00 z1= 3 -.105981736477064E-02 0.000000000000000E+00 alpha(00000386)=0.000000000000000E+00 beta (00000387)=0.123101670612152E+02 gamma(00000387)=0.123101670612152E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 387 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000387)=0.000000000000000E+00 beta (00000388)=0.138289610745615E+02 gamma(00000388)=0.138289610745615E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 388 z1= 1 -.143083321762008E-07 0.000000000000000E+00 z1= 2 -.589771956908394E-07 0.000000000000000E+00 z1= 3 0.812150100143053E-03 0.000000000000000E+00 alpha(00000388)=0.000000000000000E+00 beta (00000389)=0.130661502289192E+02 gamma(00000389)=0.130661502289192E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 389 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000389)=0.000000000000000E+00 beta (00000390)=0.133606445029367E+02 gamma(00000390)=0.133606445029367E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 390 z1= 1 -.497733354366077E-07 0.000000000000000E+00 z1= 2 0.126315063789001E-07 0.000000000000000E+00 z1= 3 -.724705285617651E-03 0.000000000000000E+00 alpha(00000390)=0.000000000000000E+00 beta (00000391)=0.129304570392076E+02 gamma(00000391)=0.129304570392076E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 391 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000391)=0.000000000000000E+00 beta (00000392)=0.131420366148527E+02 gamma(00000392)=0.131420366148527E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 392 z1= 1 -.195537457720833E-07 0.000000000000000E+00 z1= 2 -.637655292612545E-07 0.000000000000000E+00 z1= 3 0.721682193843782E-03 0.000000000000000E+00 alpha(00000392)=0.000000000000000E+00 beta (00000393)=0.132278405386264E+02 gamma(00000393)=0.132278405386264E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 393 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000393)=0.000000000000000E+00 beta (00000394)=0.136178562243421E+02 gamma(00000394)=0.136178562243421E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 394 z1= 1 -.583670570100496E-07 0.000000000000000E+00 z1= 2 0.732516618694688E-08 0.000000000000000E+00 z1= 3 -.720510424090182E-03 0.000000000000000E+00 alpha(00000394)=0.000000000000000E+00 beta (00000395)=0.120551090406157E+02 gamma(00000395)=0.120551090406157E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 395 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000395)=0.000000000000000E+00 beta (00000396)=0.140989951185449E+02 gamma(00000396)=0.140989951185449E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 396 z1= 1 -.322232430422864E-07 0.000000000000000E+00 z1= 2 -.676818610506114E-07 0.000000000000000E+00 z1= 3 0.532576511188656E-03 0.000000000000000E+00 alpha(00000396)=0.000000000000000E+00 beta (00000397)=0.132604161225066E+02 gamma(00000397)=0.132604161225066E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 397 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000397)=0.000000000000000E+00 beta (00000398)=0.143411656465577E+02 gamma(00000398)=0.143411656465577E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 398 z1= 1 -.633097955998882E-07 0.000000000000000E+00 z1= 2 -.652156415876419E-08 0.000000000000000E+00 z1= 3 -.312748463491073E-03 0.000000000000000E+00 alpha(00000398)=0.000000000000000E+00 beta (00000399)=0.120585982805696E+02 gamma(00000399)=0.120585982805696E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 399 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000399)=0.000000000000000E+00 beta (00000400)=0.133826990402982E+02 gamma(00000400)=0.133826990402982E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 400 z1= 1 -.283645048139262E-07 0.000000000000000E+00 z1= 2 -.525730168295211E-07 0.000000000000000E+00 z1= 3 0.342796306980996E-04 0.000000000000000E+00 alpha(00000400)=0.000000000000000E+00 beta (00000401)=0.129805402567996E+02 gamma(00000401)=0.129805402567996E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 401 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000401)=0.000000000000000E+00 beta (00000402)=0.133405346265251E+02 gamma(00000402)=0.133405346265251E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 402 z1= 1 -.594634434403695E-07 0.000000000000000E+00 z1= 2 -.133914594566348E-07 0.000000000000000E+00 z1= 3 0.834047874027875E-04 0.000000000000000E+00 alpha(00000402)=0.000000000000000E+00 beta (00000403)=0.129582599073853E+02 gamma(00000403)=0.129582599073853E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 403 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000403)=0.000000000000000E+00 beta (00000404)=0.138670527321124E+02 gamma(00000404)=0.138670527321124E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 404 z1= 1 -.297427999025558E-07 0.000000000000000E+00 z1= 2 -.499175959422756E-07 0.000000000000000E+00 z1= 3 -.135712476584761E-03 0.000000000000000E+00 alpha(00000404)=0.000000000000000E+00 beta (00000405)=0.134391371105185E+02 gamma(00000405)=0.134391371105185E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 405 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000405)=0.000000000000000E+00 beta (00000406)=0.135360616998369E+02 gamma(00000406)=0.135360616998369E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 406 z1= 1 -.526915615283721E-07 0.000000000000000E+00 z1= 2 -.912371787473686E-08 0.000000000000000E+00 z1= 3 0.214117367537498E-03 0.000000000000000E+00 alpha(00000406)=0.000000000000000E+00 beta (00000407)=0.131074525053105E+02 gamma(00000407)=0.131074525053105E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 407 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000407)=0.000000000000000E+00 beta (00000408)=0.139943955857967E+02 gamma(00000408)=0.139943955857967E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 408 z1= 1 -.864322434235070E-08 0.000000000000000E+00 z1= 2 -.331177713714086E-07 0.000000000000000E+00 z1= 3 -.255412184727304E-03 0.000000000000000E+00 alpha(00000408)=0.000000000000000E+00 beta (00000409)=0.128089946231960E+02 gamma(00000409)=0.128089946231960E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 409 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000409)=0.000000000000000E+00 beta (00000410)=0.126802895153759E+02 gamma(00000410)=0.126802895153759E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 410 z1= 1 -.265075091478552E-07 0.000000000000000E+00 z1= 2 0.115851026046693E-07 0.000000000000000E+00 z1= 3 0.320023996622676E-03 0.000000000000000E+00 alpha(00000410)=0.000000000000000E+00 beta (00000411)=0.129154241892047E+02 gamma(00000411)=0.129154241892047E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 411 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000411)=0.000000000000000E+00 beta (00000412)=0.138844825283100E+02 gamma(00000412)=0.138844825283100E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 412 z1= 1 0.197377374473858E-07 0.000000000000000E+00 z1= 2 -.147232523872915E-07 0.000000000000000E+00 z1= 3 -.324946935693057E-03 0.000000000000000E+00 alpha(00000412)=0.000000000000000E+00 beta (00000413)=0.123451323263153E+02 gamma(00000413)=0.123451323263153E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 413 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000413)=0.000000000000000E+00 beta (00000414)=0.137400022775562E+02 gamma(00000414)=0.137400022775562E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 414 z1= 1 -.102168774612429E-08 0.000000000000000E+00 z1= 2 0.319118946415036E-07 0.000000000000000E+00 z1= 3 0.274968943057673E-03 0.000000000000000E+00 alpha(00000414)=0.000000000000000E+00 beta (00000415)=0.129471522505659E+02 gamma(00000415)=0.129471522505659E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 415 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000415)=0.000000000000000E+00 beta (00000416)=0.130137761970156E+02 gamma(00000416)=0.130137761970156E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 416 z1= 1 0.470411599525974E-07 0.000000000000000E+00 z1= 2 0.100695923826869E-08 0.000000000000000E+00 z1= 3 -.199585894343537E-03 0.000000000000000E+00 alpha(00000416)=0.000000000000000E+00 beta (00000417)=0.120097721574732E+02 gamma(00000417)=0.120097721574732E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 417 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000417)=0.000000000000000E+00 beta (00000418)=0.128745384673698E+02 gamma(00000418)=0.128745384673698E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 418 z1= 1 0.393188108781597E-07 0.000000000000000E+00 z1= 2 0.637582676423767E-07 0.000000000000000E+00 z1= 3 -.484221669141464E-04 0.000000000000000E+00 alpha(00000418)=0.000000000000000E+00 beta (00000419)=0.133385802743973E+02 gamma(00000419)=0.133385802743973E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 419 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000419)=0.000000000000000E+00 beta (00000420)=0.138623821522826E+02 gamma(00000420)=0.138623821522826E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 420 z1= 1 0.977306341321980E-07 0.000000000000000E+00 z1= 2 0.403380691503985E-07 0.000000000000000E+00 z1= 3 0.362089653393467E-03 0.000000000000000E+00 alpha(00000420)=0.000000000000000E+00 beta (00000421)=0.126227534874561E+02 gamma(00000421)=0.126227534874561E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 421 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000421)=0.000000000000000E+00 beta (00000422)=0.143377051833098E+02 gamma(00000422)=0.143377051833098E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 422 z1= 1 0.875683846418302E-07 0.000000000000000E+00 z1= 2 0.974762822485132E-07 0.000000000000000E+00 z1= 3 -.644858122980712E-03 0.000000000000000E+00 alpha(00000422)=0.000000000000000E+00 beta (00000423)=0.124965359226548E+02 gamma(00000423)=0.124965359226548E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 423 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000423)=0.000000000000000E+00 beta (00000424)=0.132574917000445E+02 gamma(00000424)=0.132574917000445E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 424 z1= 1 0.124380278172478E-06 0.000000000000000E+00 z1= 2 0.705675631169651E-07 0.000000000000000E+00 z1= 3 0.946624138162861E-03 0.000000000000000E+00 alpha(00000424)=0.000000000000000E+00 beta (00000425)=0.129374822725116E+02 gamma(00000425)=0.129374822725116E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 425 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000425)=0.000000000000000E+00 beta (00000426)=0.143677830465401E+02 gamma(00000426)=0.143677830465401E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 426 z1= 1 0.120924416145295E-06 0.000000000000000E+00 z1= 2 0.114408452689049E-06 0.000000000000000E+00 z1= 3 -.113415935120089E-02 0.000000000000000E+00 alpha(00000426)=0.000000000000000E+00 beta (00000427)=0.130440272691666E+02 gamma(00000427)=0.130440272691666E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 427 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000427)=0.000000000000000E+00 beta (00000428)=0.142976937866310E+02 gamma(00000428)=0.142976937866310E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 428 z1= 1 0.117190981594145E-06 0.000000000000000E+00 z1= 2 0.693193576099664E-07 0.000000000000000E+00 z1= 3 0.130637181861014E-02 0.000000000000000E+00 alpha(00000428)=0.000000000000000E+00 beta (00000429)=0.122574107780199E+02 gamma(00000429)=0.122574107780199E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 429 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000429)=0.000000000000000E+00 beta (00000430)=0.134576471585684E+02 gamma(00000430)=0.134576471585684E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 430 z1= 1 0.726971362818569E-07 0.000000000000000E+00 z1= 2 0.746632420793396E-07 0.000000000000000E+00 z1= 3 -.154498434693809E-02 0.000000000000000E+00 alpha(00000430)=0.000000000000000E+00 beta (00000431)=0.126549712624387E+02 gamma(00000431)=0.126549712624387E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 431 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000431)=0.000000000000000E+00 beta (00000432)=0.136435843036809E+02 gamma(00000432)=0.136435843036809E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 432 z1= 1 0.707151708493172E-07 0.000000000000000E+00 z1= 2 0.377134307019255E-07 0.000000000000000E+00 z1= 3 0.183699900841003E-02 0.000000000000000E+00 alpha(00000432)=0.000000000000000E+00 beta (00000433)=0.128272059963191E+02 gamma(00000433)=0.128272059963191E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 433 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000433)=0.000000000000000E+00 beta (00000434)=0.140137589703320E+02 gamma(00000434)=0.140137589703320E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 434 z1= 1 0.390947284584393E-07 0.000000000000000E+00 z1= 2 0.429659207477483E-07 0.000000000000000E+00 z1= 3 -.198535922065796E-02 0.000000000000000E+00 alpha(00000434)=0.000000000000000E+00 beta (00000435)=0.118451348747444E+02 gamma(00000435)=0.118451348747444E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 435 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000435)=0.000000000000000E+00 beta (00000436)=0.130544729176769E+02 gamma(00000436)=0.130544729176769E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 436 z1= 1 0.360367731027083E-07 0.000000000000000E+00 z1= 2 0.156630057525321E-07 0.000000000000000E+00 z1= 3 0.201137458385176E-02 0.000000000000000E+00 alpha(00000436)=0.000000000000000E+00 beta (00000437)=0.122782424280273E+02 gamma(00000437)=0.122782424280273E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 437 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000437)=0.000000000000000E+00 beta (00000438)=0.138281669778044E+02 gamma(00000438)=0.138281669778044E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 438 z1= 1 0.243390324949477E-07 0.000000000000000E+00 z1= 2 0.271656229791357E-07 0.000000000000000E+00 z1= 3 -.176302999618571E-02 0.000000000000000E+00 alpha(00000438)=0.000000000000000E+00 beta (00000439)=0.133073312199321E+02 gamma(00000439)=0.133073312199321E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 439 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000439)=0.000000000000000E+00 beta (00000440)=0.134547458543527E+02 gamma(00000440)=0.134547458543527E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 440 z1= 1 0.253794121090039E-07 0.000000000000000E+00 z1= 2 0.148860070725088E-07 0.000000000000000E+00 z1= 3 0.152466414835341E-02 0.000000000000000E+00 alpha(00000440)=0.000000000000000E+00 beta (00000441)=0.133206777887243E+02 gamma(00000441)=0.133206777887243E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 441 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000441)=0.000000000000000E+00 beta (00000442)=0.135161013823815E+02 gamma(00000442)=0.135161013823815E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 442 z1= 1 0.117646603337062E-07 0.000000000000000E+00 z1= 2 0.122555838444251E-07 0.000000000000000E+00 z1= 3 -.114291292090710E-02 0.000000000000000E+00 alpha(00000442)=0.000000000000000E+00 beta (00000443)=0.124373050769643E+02 gamma(00000443)=0.124373050769643E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 443 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000443)=0.000000000000000E+00 beta (00000444)=0.136619740073088E+02 gamma(00000444)=0.136619740073088E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 444 z1= 1 0.915300291348632E-08 0.000000000000000E+00 z1= 2 0.444549848126717E-08 0.000000000000000E+00 z1= 3 0.600560621326770E-03 0.000000000000000E+00 alpha(00000444)=0.000000000000000E+00 beta (00000445)=0.133732813002037E+02 gamma(00000445)=0.133732813002037E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 445 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000445)=0.000000000000000E+00 beta (00000446)=0.136028732806432E+02 gamma(00000446)=0.136028732806432E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 446 z1= 1 -.390278418653869E-08 0.000000000000000E+00 z1= 2 0.329711625840154E-09 0.000000000000000E+00 z1= 3 -.150887315878617E-03 0.000000000000000E+00 alpha(00000446)=0.000000000000000E+00 beta (00000447)=0.132642410324226E+02 gamma(00000447)=0.132642410324226E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 447 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000447)=0.000000000000000E+00 beta (00000448)=0.134212352788056E+02 gamma(00000448)=0.134212352788056E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 448 z1= 1 -.547928659454071E-08 0.000000000000000E+00 z1= 2 -.714216047328214E-08 0.000000000000000E+00 z1= 3 -.324733623730198E-03 0.000000000000000E+00 alpha(00000448)=0.000000000000000E+00 beta (00000449)=0.127787534838813E+02 gamma(00000449)=0.127787534838813E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 449 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000449)=0.000000000000000E+00 beta (00000450)=0.127265642680084E+02 gamma(00000450)=0.127265642680084E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 450 z1= 1 -.233462031922361E-07 0.000000000000000E+00 z1= 2 -.114393492011821E-07 0.000000000000000E+00 z1= 3 0.880194985549705E-03 0.000000000000000E+00 alpha(00000450)=0.000000000000000E+00 beta (00000451)=0.127867570253534E+02 gamma(00000451)=0.127867570253534E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 451 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000451)=0.000000000000000E+00 beta (00000452)=0.130951141328697E+02 gamma(00000452)=0.130951141328697E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 452 z1= 1 -.239311937247052E-07 0.000000000000000E+00 z1= 2 -.291255938966338E-07 0.000000000000000E+00 z1= 3 -.154556587264705E-02 0.000000000000000E+00 alpha(00000452)=0.000000000000000E+00 beta (00000453)=0.120363531869132E+02 gamma(00000453)=0.120363531869132E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 453 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000453)=0.000000000000000E+00 beta (00000454)=0.141552415620532E+02 gamma(00000454)=0.141552415620532E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 454 z1= 1 -.635503320058940E-07 0.000000000000000E+00 z1= 2 -.337838039514080E-07 0.000000000000000E+00 z1= 3 0.200382935905017E-02 0.000000000000000E+00 alpha(00000454)=0.000000000000000E+00 beta (00000455)=0.124671940875651E+02 gamma(00000455)=0.124671940875651E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 455 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000455)=0.000000000000000E+00 beta (00000456)=0.140787927265161E+02 gamma(00000456)=0.140787927265161E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 456 z1= 1 -.620789730538455E-07 0.000000000000000E+00 z1= 2 -.671116353702437E-07 0.000000000000000E+00 z1= 3 -.239121495369247E-02 0.000000000000000E+00 alpha(00000456)=0.000000000000000E+00 beta (00000457)=0.120411170202352E+02 gamma(00000457)=0.120411170202352E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 457 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000457)=0.000000000000000E+00 beta (00000458)=0.135159982496064E+02 gamma(00000458)=0.135159982496064E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 458 z1= 1 -.116823649873115E-06 0.000000000000000E+00 z1= 2 -.620636843940217E-07 0.000000000000000E+00 z1= 3 0.264420549485590E-02 0.000000000000000E+00 alpha(00000458)=0.000000000000000E+00 beta (00000459)=0.128556822327673E+02 gamma(00000459)=0.128556822327673E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 459 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000459)=0.000000000000000E+00 beta (00000460)=0.138685491934147E+02 gamma(00000460)=0.138685491934147E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 460 z1= 1 -.120294041527989E-06 0.000000000000000E+00 z1= 2 -.124756377354983E-06 0.000000000000000E+00 z1= 3 -.273775993163658E-02 0.000000000000000E+00 alpha(00000460)=0.000000000000000E+00 beta (00000461)=0.132457409350460E+02 gamma(00000461)=0.132457409350460E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 461 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000461)=0.000000000000000E+00 beta (00000462)=0.132658116192048E+02 gamma(00000462)=0.132658116192048E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 462 z1= 1 -.168610036709504E-06 0.000000000000000E+00 z1= 2 -.853207866539506E-07 0.000000000000000E+00 z1= 3 0.298449680524480E-02 0.000000000000000E+00 alpha(00000462)=0.000000000000000E+00 beta (00000463)=0.120749735732186E+02 gamma(00000463)=0.120749735732186E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 463 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000463)=0.000000000000000E+00 beta (00000464)=0.130718036105254E+02 gamma(00000464)=0.130718036105254E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 464 z1= 1 -.187036198026147E-06 0.000000000000000E+00 z1= 2 -.191910299498349E-06 0.000000000000000E+00 z1= 3 -.310146096142803E-02 0.000000000000000E+00 alpha(00000464)=0.000000000000000E+00 beta (00000465)=0.126674535414897E+02 gamma(00000465)=0.126674535414897E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 465 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000465)=0.000000000000000E+00 beta (00000466)=0.139250298008273E+02 gamma(00000466)=0.139250298008273E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 466 z1= 1 -.319511464246859E-06 0.000000000000000E+00 z1= 2 -.188985843488067E-06 0.000000000000000E+00 z1= 3 0.307980553497734E-02 0.000000000000000E+00 alpha(00000466)=0.000000000000000E+00 beta (00000467)=0.125651893729754E+02 gamma(00000467)=0.125651893729754E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 467 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000467)=0.000000000000000E+00 beta (00000468)=0.132910938968749E+02 gamma(00000468)=0.132910938968749E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 468 z1= 1 -.376923663185689E-06 0.000000000000000E+00 z1= 2 -.342115051331571E-06 0.000000000000000E+00 z1= 3 -.307280030171141E-02 0.000000000000000E+00 alpha(00000468)=0.000000000000000E+00 beta (00000469)=0.133036989683127E+02 gamma(00000469)=0.133036989683127E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 469 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000469)=0.000000000000000E+00 beta (00000470)=0.143923706792743E+02 gamma(00000470)=0.143923706792743E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 470 z1= 1 -.480086875244027E-06 0.000000000000000E+00 z1= 2 -.307267725950983E-06 0.000000000000000E+00 z1= 3 0.289885476747160E-02 0.000000000000000E+00 alpha(00000470)=0.000000000000000E+00 beta (00000471)=0.127174128760740E+02 gamma(00000471)=0.127174128760740E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 471 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000471)=0.000000000000000E+00 beta (00000472)=0.137631570863042E+02 gamma(00000472)=0.137631570863042E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 472 z1= 1 -.403828904102369E-06 0.000000000000000E+00 z1= 2 -.367359473220266E-06 0.000000000000000E+00 z1= 3 -.275917396207898E-02 0.000000000000000E+00 alpha(00000472)=0.000000000000000E+00 beta (00000473)=0.125142972829049E+02 gamma(00000473)=0.125142972829049E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 473 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000473)=0.000000000000000E+00 beta (00000474)=0.138729494828939E+02 gamma(00000474)=0.138729494828939E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 474 z1= 1 -.425038771512663E-06 0.000000000000000E+00 z1= 2 -.264068579863857E-06 0.000000000000000E+00 z1= 3 0.264652020080948E-02 0.000000000000000E+00 alpha(00000474)=0.000000000000000E+00 beta (00000475)=0.127289383368309E+02 gamma(00000475)=0.127289383368309E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 475 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000475)=0.000000000000000E+00 beta (00000476)=0.132579751013632E+02 gamma(00000476)=0.132579751013632E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 476 z1= 1 -.361104848568567E-06 0.000000000000000E+00 z1= 2 -.334302907390035E-06 0.000000000000000E+00 z1= 3 -.275769238417569E-02 0.000000000000000E+00 alpha(00000476)=0.000000000000000E+00 beta (00000477)=0.132299462246475E+02 gamma(00000477)=0.132299462246475E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 477 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000477)=0.000000000000000E+00 beta (00000478)=0.146449937141488E+02 gamma(00000478)=0.146449937141488E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 478 z1= 1 -.357438678258659E-06 0.000000000000000E+00 z1= 2 -.218366009315023E-06 0.000000000000000E+00 z1= 3 0.273832336976921E-02 0.000000000000000E+00 alpha(00000478)=0.000000000000000E+00 beta (00000479)=0.125804471839074E+02 gamma(00000479)=0.125804471839074E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 479 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000479)=0.000000000000000E+00 beta (00000480)=0.134534300381395E+02 gamma(00000480)=0.134534300381395E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 480 z1= 1 -.188595818872707E-06 0.000000000000000E+00 z1= 2 -.193444167877801E-06 0.000000000000000E+00 z1= 3 -.283319682203929E-02 0.000000000000000E+00 alpha(00000480)=0.000000000000000E+00 beta (00000481)=0.125193340249884E+02 gamma(00000481)=0.125193340249884E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 481 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000481)=0.000000000000000E+00 beta (00000482)=0.136834919883855E+02 gamma(00000482)=0.136834919883855E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 482 z1= 1 -.124414829178712E-06 0.000000000000000E+00 z1= 2 -.534680419961590E-07 0.000000000000000E+00 z1= 3 0.277625494409535E-02 0.000000000000000E+00 alpha(00000482)=0.000000000000000E+00 beta (00000483)=0.125909358300998E+02 gamma(00000483)=0.125909358300998E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 483 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000483)=0.000000000000000E+00 beta (00000484)=0.138554014719968E+02 gamma(00000484)=0.138554014719968E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 484 z1= 1 0.312602942779939E-08 0.000000000000000E+00 z1= 2 -.304895155135308E-07 0.000000000000000E+00 z1= 3 -.275684631126231E-02 0.000000000000000E+00 alpha(00000484)=0.000000000000000E+00 beta (00000485)=0.129165989219934E+02 gamma(00000485)=0.129165989219934E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 485 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000485)=0.000000000000000E+00 beta (00000486)=0.135108271116576E+02 gamma(00000486)=0.135108271116576E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 486 z1= 1 0.741819596849493E-07 0.000000000000000E+00 z1= 2 0.775858603975412E-07 0.000000000000000E+00 z1= 3 0.290635275323806E-02 0.000000000000000E+00 alpha(00000486)=0.000000000000000E+00 beta (00000487)=0.125102197988649E+02 gamma(00000487)=0.125102197988649E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 487 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000487)=0.000000000000000E+00 beta (00000488)=0.132778039288789E+02 gamma(00000488)=0.132778039288789E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 488 z1= 1 0.205307110205460E-06 0.000000000000000E+00 z1= 2 0.140499072886840E-06 0.000000000000000E+00 z1= 3 -.301943245999885E-02 0.000000000000000E+00 alpha(00000488)=0.000000000000000E+00 beta (00000489)=0.128862942831106E+02 gamma(00000489)=0.128862942831106E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 489 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000489)=0.000000000000000E+00 beta (00000490)=0.137909025349009E+02 gamma(00000490)=0.137909025349009E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 490 z1= 1 0.307628116921765E-06 0.000000000000000E+00 z1= 2 0.236749452366271E-06 0.000000000000000E+00 z1= 3 0.308592866367510E-02 0.000000000000000E+00 alpha(00000490)=0.000000000000000E+00 beta (00000491)=0.131322789959306E+02 gamma(00000491)=0.131322789959306E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 491 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000491)=0.000000000000000E+00 beta (00000492)=0.129316740337057E+02 gamma(00000492)=0.129316740337057E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 492 z1= 1 0.419477393383326E-06 0.000000000000000E+00 z1= 2 0.318811600369504E-06 0.000000000000000E+00 z1= 3 -.341119794471416E-02 0.000000000000000E+00 alpha(00000492)=0.000000000000000E+00 beta (00000493)=0.123825504408958E+02 gamma(00000493)=0.123825504408958E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 493 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000493)=0.000000000000000E+00 beta (00000494)=0.142822173664785E+02 gamma(00000494)=0.142822173664785E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 494 z1= 1 0.582866516186172E-06 0.000000000000000E+00 z1= 2 0.429131848212394E-06 0.000000000000000E+00 z1= 3 0.317190797378671E-02 0.000000000000000E+00 alpha(00000494)=0.000000000000000E+00 beta (00000495)=0.121301148137349E+02 gamma(00000495)=0.121301148137349E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 495 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000495)=0.000000000000000E+00 beta (00000496)=0.141044667519879E+02 gamma(00000496)=0.141044667519879E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 496 z1= 1 0.758624799962590E-06 0.000000000000000E+00 z1= 2 0.588426698019083E-06 0.000000000000000E+00 z1= 3 -.289586978449015E-02 0.000000000000000E+00 alpha(00000496)=0.000000000000000E+00 beta (00000497)=0.126650923183724E+02 gamma(00000497)=0.126650923183724E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 497 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000497)=0.000000000000000E+00 beta (00000498)=0.139396838078370E+02 gamma(00000498)=0.139396838078370E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 498 z1= 1 0.893238060055738E-06 0.000000000000000E+00 z1= 2 0.648305029584935E-06 0.000000000000000E+00 z1= 3 0.273092317572166E-02 0.000000000000000E+00 alpha(00000498)=0.000000000000000E+00 beta (00000499)=0.124008114239921E+02 gamma(00000499)=0.124008114239921E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 499 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000499)=0.000000000000000E+00 beta (00000500)=0.138711247232245E+02 gamma(00000500)=0.138711247232245E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 500 z1= 1 0.102788083214411E-05 0.000000000000000E+00 z1= 2 0.809980880066622E-06 0.000000000000000E+00 z1= 3 -.254161852415506E-02 0.000000000000000E+00 alpha(00000500)=0.000000000000000E+00 beta (00000501)=0.131302717479693E+02 gamma(00000501)=0.131302717479693E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal End of Lanczos iterations Finished linear response calculation... lr_main : 875.04s CPU 1051.29s WALL ( 1 calls) lr_solve_e : 0.40s CPU 0.47s WALL ( 1 calls) one_step : 874.32s CPU 1050.09s WALL ( 1500 calls) lr_apply : 870.34s CPU 1044.14s WALL ( 3006 calls) lr_apply_int : 447.49s CPU 541.26s WALL ( 1503 calls) lr_bse_int : 180.20s CPU 219.46s WALL ( 3006 calls) lr_apply_no : 422.84s CPU 502.95s WALL ( 1503 calls) lr_bse_noint : 200.30s CPU 239.45s WALL ( 1503 calls) lr_apply : 870.34s CPU 1044.14s WALL ( 3006 calls) h_psi : 435.00s CPU 518.18s WALL ( 3006 calls) lr_calc_dens : 202.79s CPU 246.50s WALL ( 1503 calls) lr_ortho : 1.34s CPU 1.47s WALL ( 3000 calls) interaction : 15.55s CPU 18.06s WALL ( 1503 calls) lr_dot : 1.92s CPU 2.75s WALL ( 3753 calls) US routines lr_sm1_psi : 0.04s CPU 0.04s WALL ( 3006 calls) General routines calbec : 1.35s CPU 1.66s WALL ( 4587 calls) fft : 12.79s CPU 16.35s WALL ( 3009 calls) ffts : 519.42s CPU 605.79s WALL ( 96216 calls) fftw : 170.72s CPU 203.36s WALL ( 48236 calls) interpolate : 0.14s CPU 0.19s WALL ( 1503 calls) davcio : 0.00s CPU 0.00s WALL ( 49 calls) Parallel routines fft_scatter : 479.57s CPU 529.92s WALL ( 147461 calls) EXX routines exx_grid : 0.00s CPU 0.00s WALL ( 1 calls) exxinit : 0.01s CPU 0.03s WALL ( 1 calls) vexx : 399.21s CPU 474.92s WALL ( 3006 calls) exxen2 : 0.04s CPU 0.06s WALL ( 1 calls) TDDFPT : 14m35.06s CPU 17m31.32s WALL This run was terminated on: 17:12:54 14Dec2011 =------------------------------------------------------------------------------= JOB DONE. =------------------------------------------------------------------------------= TDDFPT/Examples/CH4-TDHF/CH4.tddfpt_pp-in0000644000175000017500000000025012341371500015663 0ustar mbamba&lr_input prefix='ch4', outdir='./out', itermax=10000 itermax0=450 extrapolation="osc" epsil=0.01 end=3.50d0 increment=0.001d0 start=0.0d0 ipol=4 / TDDFPT/Examples/CH4-TDHF/Makefile0000644000175000017500000000077512341371500014447 0ustar mbambainclude ../make.sys NAME = CH4 default : all all : check_results check_results: $(NAME).pw-out $(NAME).tddfpt-out $(NAME).tddfpt_pp-out $(check_pw) $(NAME).pw-out $(NAME).pw-ref $(check_tddfpt) $(NAME).tddfpt-out $(NAME).tddfpt-ref small_test: $(NAME).pw-out $(NAME).tddfpt-st-out @$(check_pw) $(NAME).pw-out $(NAME).pw-ref @$(check_tddfpt) $(NAME).tddfpt-st-out $(NAME).tddfpt-st-ref clean : - /bin/rm -rf $(NAME).pw-out $(NAME).tddfpt-out $(NAME).tddfpt_pp-out $(NAME).tddfpt-st-out *.plot out/* TDDFPT/Examples/CH4-TDHF/CH4.tddfpt-st-ref0000644000175000017500000001442112341371500015763 0ustar mbamba Program TDDFPT v.4.3.2 starts on 14Dec2011 at 16:55: 4 This program is part of the open-source Quantum ESPRESSO suite for quantum simulation of materials; please cite "P. Giannozzi et al., J. Phys.:Condens. Matter 21 395502 (2009); URL http://www.quantum-espresso.org", in publications or presentations arising from this work. More details at http://www.quantum-espresso.org/quote.php Parallel version (MPI), running on 4 processors R & G space division: proc/pool = 4 ---------------------------------------- This is TDDFPT (Time Dependent Density Functional Perturbation Theory) Sub Version: 0.9 ---------------------------------------- Ultrasoft (Vanderbilt) Pseudopotentials Info: using nr1, nr2, nr3 values from input Info: using nr1s, nr2s, nr3s values from input IMPORTANT: XC functional enforced from input : Exchange-correlation = HF ( 5 0 0 0 0) EXX-fraction = 1.00 Any further DFT definition will be discarded Please, verify this is what you really want file H.pz-vbc.UPF: wavefunction(s) 1S renormalized Parallelization info -------------------- sticks: dense smooth PW G-vecs: dense smooth PW Min 445 445 108 14262 14262 1776 Max 452 452 110 14264 14264 1783 Sum 1789 1789 437 57051 57051 7123 Tot 895 895 219 IMPORTANT: XC functional enforced from input : Exchange-correlation = HF ( 5 0 0 0 0) EXX-fraction = 1.00 Any further DFT definition will be discarded Please, verify this is what you really want EXX fraction changed: 1.00 EXX Screening parameter changed: 0.0000000 Subspace diagonalization in iterative solution of the eigenvalue problem: a serial algorithm will be used Lanczos linear response spectrum calculation Number of Lanczos iterations = 5 Gamma point algorithm Is it hybrid? T Is it hybrid? T Is it hybrid? T Is it hybrid? T hf commutator NOT used lr_wfcinit_spectrum: finished lr_solve_e Norm of initial Lanczos vectors= 0.939778515381034 Starting Lanczos loop 1 Lanczos iteration: 1 z1= 1 0.000000000000000E+00 0.000000000000000E+00 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal alpha(00000001)=0.000000000000000E+00 beta (00000002)=0.199314489592837E+01 gamma(00000002)=0.199314489592837E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 2 z1= 1 0.629699439613743E+00 0.000000000000000E+00 alpha(00000002)=0.000000000000000E+00 beta (00000003)=0.670063390421906E+01 gamma(00000003)=0.670063390421906E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 3 z1= 1 0.000000000000000E+00 0.000000000000000E+00 alpha(00000003)=0.000000000000000E+00 beta (00000004)=0.145136710095232E+02 gamma(00000004)=0.145136710095232E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 4 z1= 1 -.232649452883497E+00 0.000000000000000E+00 alpha(00000004)=0.000000000000000E+00 beta (00000005)=0.122818116856415E+02 gamma(00000005)=0.122818116856415E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 5 z1= 1 0.000000000000000E+00 0.000000000000000E+00 alpha(00000005)=0.000000000000000E+00 beta (00000006)=0.140748544373869E+02 gamma(00000006)=0.140748544373869E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal End of Lanczos iterations Finished linear response calculation... lr_main : 4.13s CPU 5.14s WALL ( 1 calls) lr_solve_e : 0.13s CPU 0.14s WALL ( 1 calls) one_step : 3.62s CPU 4.53s WALL ( 5 calls) lr_apply : 3.61s CPU 4.52s WALL ( 12 calls) lr_apply_int : 1.24s CPU 1.68s WALL ( 6 calls) lr_bse_int : 0.49s CPU 0.68s WALL ( 12 calls) lr_apply_no : 2.37s CPU 2.84s WALL ( 6 calls) lr_bse_noint : 1.74s CPU 1.95s WALL ( 6 calls) lr_apply : 3.61s CPU 4.52s WALL ( 12 calls) h_psi : 1.23s CPU 1.70s WALL ( 12 calls) lr_calc_dens : 0.55s CPU 0.75s WALL ( 6 calls) lr_ortho : 0.00s CPU 0.00s WALL ( 10 calls) interaction : 0.04s CPU 0.05s WALL ( 6 calls) lr_dot : 0.00s CPU 0.00s WALL ( 8 calls) US routines lr_sm1_psi : 0.00s CPU 0.00s WALL ( 12 calls) General routines calbec : 0.02s CPU 0.02s WALL ( 44 calls) fft : 0.07s CPU 0.08s WALL ( 15 calls) ffts : 2.50s CPU 2.85s WALL ( 408 calls) fftw : 0.59s CPU 0.77s WALL ( 244 calls) interpolate : 0.00s CPU 0.00s WALL ( 6 calls) davcio : 0.00s CPU 0.00s WALL ( 11 calls) Parallel routines fft_scatter : 2.13s CPU 2.29s WALL ( 667 calls) EXX routines exx_grid : 0.00s CPU 0.00s WALL ( 1 calls) exxinit : 0.02s CPU 0.03s WALL ( 1 calls) vexx : 1.13s CPU 1.56s WALL ( 12 calls) exxen2 : 0.07s CPU 0.07s WALL ( 1 calls) TDDFPT : 4.13s CPU 5.14s WALL This run was terminated on: 16:55: 9 14Dec2011 =------------------------------------------------------------------------------= JOB DONE. =------------------------------------------------------------------------------= TDDFPT/Examples/CH4-ENVIRON/0000755000175000017500000000000012341371517013401 5ustar mbambaTDDFPT/Examples/CH4-ENVIRON/CH4.tddfpt-in0000644000175000017500000000073312341371500015565 0ustar mbamba&lr_input prefix="ch4", outdir='./out', restart_step=250, restart = .false. lr_verbosity = 1 / &lr_control itermax=500, pseudo_hermitian = .true. no_hxc = .false. ipol=4 n_ipol = 3 / &environ verbose = 0 environ_thr = 1.d-1 environ_type = 'input' tolrhopol = 1.D-12 mixrhopol = 0.6 env_static_permittivity = 78.3D0 env_optical_permittivity = 1.776D0 env_surface_tension = 0.D0 env_pressure = 0.D0 / TDDFPT/Examples/CH4-ENVIRON/CH4.tddfpt_pp-ref0000644000175000017500000000404512341371500016432 0ustar mbamba Warning: Only a single cpu will be used! Program TDDFPT_PP v.5.0.2 (svn rev. 10732M) starts on 8Feb2014 at 18:42:48 This program is part of the open-source Quantum ESPRESSO suite for quantum simulation of materials; please cite "P. Giannozzi et al., J. Phys.:Condens. Matter 21 395502 (2009); URL http://www.quantum-espresso.org", in publications or presentations arising from this work. More details at http://www.quantum-espresso.org/quote Parallel version (MPI), running on 4 processors R & G space division: proc/nbgrp/npool/nimage = 4 Calculation is finished. Calculation is finished. Calculation is finished. Reading 500 Lanczos steps for direction 1 500 steps will be considered Reading 500 Lanczos steps for direction 2 500 steps will be considered Reading 500 Lanczos steps for direction 3 500 steps will be considered Polarization direction:1 Average = 13.02094308 Average oscillation amplitude = 0.35164911 Polarization direction:2 Average = 13.02091602 Average oscillation amplitude = 0.35165046 Polarization direction:3 Average = 13.02094712 Average oscillation amplitude = 0.35164847 Data ready, starting to calculate observables Broadening = 0.01000000 Ry Output file name: ch4.plot chi_i_j: dipole polarizability tensor in units of e^2*a_0^2/energy S: oscillator strength in units of 1/energy S(\hbar \omega) = 2m/( 3 \pi e^2 \hbar) \omega sum_j chi_j_j S(\hbar \omega) satisfies the f-sum rule: \int_0^\infty dE S(E) = N_el Functions are reported in \hbar.\omega Energy unit is (Ry) TDDFPT_PP : 26.32s CPU 26.60s WALL This run was terminated on: 18:43:14 8Feb2014 =------------------------------------------------------------------------------= JOB DONE. =------------------------------------------------------------------------------= Calculation is finished. TDDFPT/Examples/CH4-ENVIRON/CH4.pw-in0000644000175000017500000000141312341371500014722 0ustar mbamba&control calculation = 'scf' title = 'TDDFPT CH4 Test (Environ)' restart_mode='from_scratch', pseudo_dir = '../pseudo', outdir='./out', prefix='ch4' / &system ibrav = 1, celldm(1) = 20, nat = 5, ntyp = 2, ecutwfc = 25, nosym=.true. / &electrons diagonalization = 'davidson' mixing_mode = 'plain', conv_thr = 1.0d-8, mixing_beta = 0.7 electron_maxstep = 100 / ATOMIC_SPECIES C 12.001 C.pz-vbc.UPF H 1.008 H.pz-vbc.UPF ATOMIC_POSITIONS {Angstrom} C 0.000000000 0.000000000 0.000000000 H 0.642814093 0.642814093 0.642814093 H -0.642814093 -0.642814093 0.642814093 H 0.642814093 -0.642814093 -0.642814093 H -0.642814093 0.642814093 -0.642814093 K_POINTS {gamma} TDDFPT/Examples/CH4-ENVIRON/environ.in0000644000175000017500000000032512341371500015401 0ustar mbamba&environ verbose = 0 environ_thr = 1.d-1 environ_type = 'input' tolrhopol = 1.D-12 mixrhopol = 0.6 env_static_permittivity = 78.3D0 env_surface_tension = 0.D0 env_pressure = 0.D0 / TDDFPT/Examples/CH4-ENVIRON/README0000644000175000017500000000037112341371500014252 0ustar mbambaIn order to run this example using the Environ module, you must modify the TDDFPT/Examples/make.sys : you must use the --environ option with pw.x and turbo_lanczos.x Replace $(PWSCF) by $(PWSCF) --environ Replace $(TDDFPT) by $(TDDFPT) --environ TDDFPT/Examples/CH4-ENVIRON/CH4.pw-ref0000644000175000017500000003272212341371500015077 0ustar mbamba Program PWSCF v.5.0.2 (svn rev. 10732M) starts on 8Feb2014 at 18:23: 7 This program is part of the open-source Quantum ESPRESSO suite for quantum simulation of materials; please cite "P. Giannozzi et al., J. Phys.:Condens. Matter 21 395502 (2009); URL http://www.quantum-espresso.org", in publications or presentations arising from this work. More details at http://www.quantum-espresso.org/quote Parallel version (MPI), running on 4 processors R & G space division: proc/nbgrp/npool/nimage = 4 Waiting for input... Reading input from standard input Current dimensions of program PWSCF are: Max number of different atomic species (ntypx) = 10 Max number of k-points (npk) = 40000 Max angular momentum in pseudopotentials (lmaxx) = 3 file H.pz-vbc.UPF: wavefunction(s) 1S renormalized gamma-point specific algorithms are used Subspace diagonalization in iterative solution of the eigenvalue problem: a serial algorithm will be used Parallelization info -------------------- sticks: dense smooth PW G-vecs: dense smooth PW Min 793 793 197 33759 33759 4218 Max 798 798 200 33762 33762 4224 Sum 3181 3181 793 135043 135043 16879 Tot 1591 1591 397 Title: TDDFPT CH4 Test (Environ) bravais-lattice index = 1 lattice parameter (alat) = 20.0000 a.u. unit-cell volume = 8000.0000 (a.u.)^3 number of atoms/cell = 5 number of atomic types = 2 number of electrons = 8.00 number of Kohn-Sham states= 4 kinetic-energy cutoff = 25.0000 Ry charge density cutoff = 100.0000 Ry convergence threshold = 1.0E-08 mixing beta = 0.7000 number of iterations used = 8 plain mixing Exchange-correlation = SLA PZ NOGX NOGC ( 1 1 0 0 0) Environ Module ============== Please cite "O. Andreussi, I. Dabo and N. Marzari, J. Chem. Phys. 136, 064102 (2012);" in publications or presentations arising from this work. compensation onset threshold = 0.1000E+00 switching function adopted = SCCS density limit for vacuum region = 0.5000E-02 density limit for bulk solvent = 0.1000E-03 static permittivity = 78.30 epsilon calculation mode = electronic type of numerical differentiator = central diff. number of points in num. diff. = 2 required accuracy = 0.1000E-11 linear mixing parameter = 0.60 celldm(1)= 20.000000 celldm(2)= 0.000000 celldm(3)= 0.000000 celldm(4)= 0.000000 celldm(5)= 0.000000 celldm(6)= 0.000000 crystal axes: (cart. coord. in units of alat) a(1) = ( 1.000000 0.000000 0.000000 ) a(2) = ( 0.000000 1.000000 0.000000 ) a(3) = ( 0.000000 0.000000 1.000000 ) reciprocal axes: (cart. coord. in units 2 pi/alat) b(1) = ( 1.000000 0.000000 0.000000 ) b(2) = ( 0.000000 1.000000 0.000000 ) b(3) = ( 0.000000 0.000000 1.000000 ) PseudoPot. # 1 for C read from file: ../pseudo/C.pz-vbc.UPF MD5 check sum: ab53dd623bfeb79c5a7b057bc96eae20 Pseudo is Norm-conserving, Zval = 4.0 Generated by new atomic code, or converted to UPF format Using radial grid of 269 points, 1 beta functions with: l(1) = 0 PseudoPot. # 2 for H read from file: ../pseudo/H.pz-vbc.UPF MD5 check sum: 90becb985b714f09656c73597998d266 Pseudo is Norm-conserving, Zval = 1.0 Generated by new atomic code, or converted to UPF format Using radial grid of 131 points, 0 beta functions with: atomic species valence mass pseudopotential C 4.00 12.00100 C ( 1.00) H 1.00 1.00800 H ( 1.00) No symmetry found Cartesian axes site n. atom positions (alat units) 1 C tau( 1) = ( 0.0000000 0.0000000 0.0000000 ) 2 H tau( 2) = ( 0.0607371 0.0607371 0.0607371 ) 3 H tau( 3) = ( -0.0607371 -0.0607371 0.0607371 ) 4 H tau( 4) = ( 0.0607371 -0.0607371 -0.0607371 ) 5 H tau( 5) = ( -0.0607371 0.0607371 -0.0607371 ) number of k points= 1 cart. coord. in units 2pi/alat k( 1) = ( 0.0000000 0.0000000 0.0000000), wk = 2.0000000 Dense grid: 67522 G-vectors FFT dimensions: ( 64, 64, 64) Largest allocated arrays est. size (Mb) dimensions Kohn-Sham Wavefunctions 0.13 Mb ( 2112, 4) NL pseudopotentials 0.03 Mb ( 2112, 1) Each V/rho on FFT grid 1.00 Mb ( 65536) Each G-vector array 0.13 Mb ( 16881) G-vector shells 0.01 Mb ( 836) Largest temporary arrays est. size (Mb) dimensions Auxiliary wavefunctions 0.26 Mb ( 2112, 16) Each subspace H/S matrix 0.00 Mb ( 16, 16) Each matrix 0.00 Mb ( 1, 4) Arrays for rho mixing 8.00 Mb ( 65536, 8) Initial potential from superposition of free atoms Check: negative starting charge= -0.018345 starting charge 7.99987, renormalised to 8.00000 negative rho (up, down): 1.835E-02 0.000E+00 Starting wfc are 8 randomized atomic wfcs total cpu time spent up to now is 0.4 secs per-process dynamical memory: 18.0 Mb Self-consistent Calculation iteration # 1 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 1.00E-02, avg # of iterations = 2.0 negative rho (up, down): 5.277E-03 0.000E+00 total cpu time spent up to now is 0.8 secs total energy = -15.61302023 Ry Harris-Foulkes estimate = -15.99206759 Ry estimated scf accuracy < 0.55751804 Ry solvation energy = 0.00000000 Ry iteration # 2 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 6.97E-03, avg # of iterations = 2.0 negative rho (up, down): 2.690E-03 0.000E+00 total cpu time spent up to now is 1.0 secs total energy = -15.73727219 Ry Harris-Foulkes estimate = -15.84012769 Ry estimated scf accuracy < 0.18813531 Ry solvation energy = 0.00000000 Ry iteration # 3 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 2.35E-03, avg # of iterations = 2.0 negative rho (up, down): 5.168E-05 0.000E+00 add environment contribution to local potential polarization accuracy = 7.7E-13, # of iterations = 34 total cpu time spent up to now is 5.9 secs total energy = -15.77628437 Ry Harris-Foulkes estimate = -15.77879948 Ry estimated scf accuracy < 0.00498929 Ry solvation energy = 0.00000000 Ry iteration # 4 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 6.24E-05, avg # of iterations = 2.0 negative rho (up, down): 1.932E-05 0.000E+00 add environment contribution to local potential polarization accuracy = 9.0E-13, # of iterations = 25 total cpu time spent up to now is 8.3 secs total energy = -15.77989915 Ry Harris-Foulkes estimate = -15.72907365 Ry estimated scf accuracy < 0.00069851 Ry solvation energy = -0.00214638 Ry iteration # 5 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 8.73E-06, avg # of iterations = 1.0 negative rho (up, down): 6.987E-06 0.000E+00 add environment contribution to local potential polarization accuracy = 9.9E-13, # of iterations = 28 total cpu time spent up to now is 10.9 secs total energy = -15.77967616 Ry Harris-Foulkes estimate = -15.72581749 Ry estimated scf accuracy < 0.00018245 Ry solvation energy = -0.00235516 Ry iteration # 6 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 2.28E-06, avg # of iterations = 2.0 add environment contribution to local potential polarization accuracy = 7.4E-13, # of iterations = 25 total cpu time spent up to now is 13.3 secs total energy = -15.77997329 Ry Harris-Foulkes estimate = -15.72590809 Ry estimated scf accuracy < 0.00008538 Ry solvation energy = -0.00255830 Ry iteration # 7 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 1.07E-06, avg # of iterations = 2.0 add environment contribution to local potential polarization accuracy = 9.1E-13, # of iterations = 18 total cpu time spent up to now is 15.1 secs total energy = -15.77994228 Ry Harris-Foulkes estimate = -15.72572499 Ry estimated scf accuracy < 0.00000106 Ry solvation energy = -0.00250313 Ry iteration # 8 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 1.33E-08, avg # of iterations = 2.0 add environment contribution to local potential polarization accuracy = 9.6E-13, # of iterations = 13 total cpu time spent up to now is 16.7 secs total energy = -15.77993900 Ry Harris-Foulkes estimate = -15.72593704 Ry estimated scf accuracy < 0.00000016 Ry solvation energy = -0.00249905 Ry iteration # 9 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 2.05E-09, avg # of iterations = 2.0 total cpu time spent up to now is 16.9 secs End of self-consistent calculation k = 0.0000 0.0000 0.0000 ( 8440 PWs) bands (ev): -16.6899 -9.0803 -9.0803 -9.0803 highest occupied level (ev): -9.0803 ! total energy = -15.77993867 Ry Harris-Foulkes estimate = -15.72593384 Ry estimated scf accuracy < 1.7E-09 Ry The total energy is the sum of the following terms: one-electron contribution = -40.17861106 Ry hartree contribution = 20.82329267 Ry xc contribution = -6.06639229 Ry ewald contribution = 9.69577685 Ry solvation energy = -0.00249870 Ry convergence has been achieved in 9 iterations Writing output data file ch4.save init_run : 0.23s CPU 0.30s WALL ( 1 calls) electrons : 14.03s CPU 16.53s WALL ( 1 calls) Called by init_run: wfcinit : 0.13s CPU 0.18s WALL ( 1 calls) potinit : 0.05s CPU 0.06s WALL ( 1 calls) Called by electrons: c_bands : 0.74s CPU 0.84s WALL ( 9 calls) sum_band : 0.37s CPU 0.38s WALL ( 9 calls) v_of_rho : 0.21s CPU 0.21s WALL ( 10 calls) mix_rho : 0.28s CPU 0.29s WALL ( 9 calls) Called by c_bands: init_us_2 : 0.00s CPU 0.01s WALL ( 19 calls) regterg : 0.72s CPU 0.81s WALL ( 9 calls) Called by *egterg: h_psi : 0.81s CPU 0.93s WALL ( 27 calls) g_psi : 0.00s CPU 0.00s WALL ( 17 calls) rdiaghg : 0.00s CPU 0.00s WALL ( 26 calls) Called by h_psi: add_vuspsi : 0.00s CPU 0.00s WALL ( 27 calls) General routines calbec : 0.00s CPU 0.01s WALL ( 27 calls) fft : 7.14s CPU 7.34s WALL ( 677 calls) fftw : 0.75s CPU 0.86s WALL ( 130 calls) davcio : 0.00s CPU 0.00s WALL ( 1 calls) Parallel routines fft_scatter : 5.37s CPU 5.63s WALL ( 807 calls) Environ routines calc_esolv : 0.27s CPU 0.28s WALL ( 9 calls) calc_vsolv : 11.63s CPU 13.88s WALL ( 6 calls) dielectric : 1.04s CPU 1.08s WALL ( 6 calls) get_rhopol : 10.41s CPU 12.61s WALL ( 6 calls) calc_veps : 0.39s CPU 0.40s WALL ( 6 calls) PWSCF : 14.40s CPU 17.17s WALL This run was terminated on: 18:23:24 8Feb2014 =------------------------------------------------------------------------------= JOB DONE. =------------------------------------------------------------------------------= TDDFPT/Examples/CH4-ENVIRON/CH4.tddfpt-ref0000644000175000017500000263043512341371500015745 0ustar mbamba Program turboTDDFT v.5.0.2 (svn rev. 10732M) starts on 8Feb2014 at 18:23:25 This program is part of the open-source Quantum ESPRESSO suite for quantum simulation of materials; please cite "P. Giannozzi et al., J. Phys.:Condens. Matter 21 395502 (2009); URL http://www.quantum-espresso.org", in publications or presentations arising from this work. More details at http://www.quantum-espresso.org/quote Parallel version (MPI), running on 4 processors R & G space division: proc/nbgrp/npool/nimage = 4 Info: using nr1, nr2, nr3 values from input Info: using nr1s, nr2s, nr3s values from input IMPORTANT: XC functional enforced from input : Exchange-correlation = SLA PZ NOGX NOGC ( 1 1 0 0 0) Any further DFT definition will be discarded Please, verify this is what you really want file H.pz-vbc.UPF: wavefunction(s) 1S renormalized Parallelization info -------------------- sticks: dense smooth PW G-vecs: dense smooth PW Min 793 793 197 33759 33759 4218 Max 798 798 200 33762 33762 4224 Sum 3181 3181 793 135043 135043 16879 Tot 1591 1591 397 Computing and adding the polarization potentials to H+XC potential polarization accuracy = 8.2E-13, # of iterations = 34 Subspace diagonalization in iterative solution of the eigenvalue problem: a serial algorithm will be used Environ Module ============== Please cite "O. Andreussi, I. Dabo and N. Marzari, J. Chem. Phys. 136, 064102 (2012);" in publications or presentations arising from this work. compensation onset threshold = 0.1000E+00 switching function adopted = SCCS density limit for vacuum region = 0.5000E-02 density limit for bulk solvent = 0.1000E-03 static permittivity = 78.30 optical permittivity = 1.78 epsilon calculation mode = electronic type of numerical differentiator = central diff. number of points in num. diff. = 2 required accuracy = 0.1000E-11 linear mixing parameter = 0.60 Lanczos linear response spectrum calculation Number of Lanczos iterations = 500 Normal read Gamma point algorithm Finished reading wfc. Finished exx setting. lr_wfcinit_spectrum: finished lr_solve_e Reading d0psi Starting Lanczos loop 1 Lanczos iteration: 1 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000001)= 0.000000000000000E+00 beta (00000001)= 0.198590100226994E+01 gamma(00000001)= 0.198590100226994E+01 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 2 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.9E-13, # of iterations = 17 lr_apply_liouvillian: applying interaction: normal alpha(00000002)= 0.000000000000000E+00 beta (00000002)= 0.266004824369529E+01 gamma(00000002)= 0.266004824369529E+01 z1= 1 0.746565783901409E+00 0.000000000000000E+00 z1= 2 -0.607268718040566E-06 0.000000000000000E+00 z1= 3 0.153149888995662E-07 0.000000000000000E+00 Lanczos iteration: 3 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000003)= 0.000000000000000E+00 beta (00000003)= 0.941282295453222E+01 gamma(00000003)= 0.941282295453222E+01 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 4 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.7E-13, # of iterations = 18 lr_apply_liouvillian: applying interaction: normal alpha(00000004)= 0.000000000000000E+00 beta (00000004)= 0.143357401162660E+02 gamma(00000004)= 0.143357401162660E+02 z1= 1 -0.490193843553429E+00 0.000000000000000E+00 z1= 2 0.427948066945155E-06 0.000000000000000E+00 z1= 3 -0.112634734239698E-07 0.000000000000000E+00 Lanczos iteration: 5 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000005)= 0.000000000000000E+00 beta (00000005)= 0.121882071576535E+02 gamma(00000005)= 0.121882071576535E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 6 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.9E-13, # of iterations = 19 lr_apply_liouvillian: applying interaction: normal alpha(00000006)= 0.000000000000000E+00 beta (00000006)= 0.138954302763563E+02 gamma(00000006)= 0.138954302763563E+02 z1= 1 0.429967395148320E+00 0.000000000000000E+00 z1= 2 -0.411456860013870E-06 0.000000000000000E+00 z1= 3 0.928460522977041E-08 0.000000000000000E+00 Lanczos iteration: 7 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000007)= 0.000000000000000E+00 beta (00000007)= 0.124798928408784E+02 gamma(00000007)= 0.124798928408784E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 8 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 19 lr_apply_liouvillian: applying interaction: normal alpha(00000008)= 0.000000000000000E+00 beta (00000008)= 0.135517518678615E+02 gamma(00000008)= 0.135517518678615E+02 z1= 1 -0.395960654186511E+00 0.000000000000000E+00 z1= 2 0.418350379807059E-06 0.000000000000000E+00 z1= 3 -0.897140373605889E-08 0.000000000000000E+00 Lanczos iteration: 9 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000009)= 0.000000000000000E+00 beta (00000009)= 0.126276630161033E+02 gamma(00000009)= 0.126276630161033E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 10 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.3E-13, # of iterations = 18 lr_apply_liouvillian: applying interaction: normal alpha(00000010)= 0.000000000000000E+00 beta (00000010)= 0.134087298390140E+02 gamma(00000010)= 0.134087298390140E+02 z1= 1 0.372894727497223E+00 0.000000000000000E+00 z1= 2 -0.431800810503369E-06 0.000000000000000E+00 z1= 3 0.101629183235207E-07 0.000000000000000E+00 Lanczos iteration: 11 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000011)= 0.000000000000000E+00 beta (00000011)= 0.126837793556890E+02 gamma(00000011)= 0.126837793556890E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 12 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.4E-13, # of iterations = 18 lr_apply_liouvillian: applying interaction: normal alpha(00000012)= 0.000000000000000E+00 beta (00000012)= 0.133788052985161E+02 gamma(00000012)= 0.133788052985161E+02 z1= 1 -0.353517023877594E+00 0.000000000000000E+00 z1= 2 0.443588922692875E-06 0.000000000000000E+00 z1= 3 -0.107780451835053E-07 0.000000000000000E+00 Lanczos iteration: 13 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000013)= 0.000000000000000E+00 beta (00000013)= 0.126912024625553E+02 gamma(00000013)= 0.126912024625553E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 14 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.7E-13, # of iterations = 18 lr_apply_liouvillian: applying interaction: normal alpha(00000014)= 0.000000000000000E+00 beta (00000014)= 0.134095381513224E+02 gamma(00000014)= 0.134095381513224E+02 z1= 1 0.334569164102424E+00 0.000000000000000E+00 z1= 2 -0.451435670095757E-06 0.000000000000000E+00 z1= 3 0.101988038202433E-07 0.000000000000000E+00 Lanczos iteration: 15 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000015)= 0.000000000000000E+00 beta (00000015)= 0.127243795901678E+02 gamma(00000015)= 0.127243795901678E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 16 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.9E-13, # of iterations = 18 lr_apply_liouvillian: applying interaction: normal alpha(00000016)= 0.000000000000000E+00 beta (00000016)= 0.134837687126638E+02 gamma(00000016)= 0.134837687126638E+02 z1= 1 -0.315714521733208E+00 0.000000000000000E+00 z1= 2 0.454697434535897E-06 0.000000000000000E+00 z1= 3 -0.863612582618564E-08 0.000000000000000E+00 Lanczos iteration: 17 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000017)= 0.000000000000000E+00 beta (00000017)= 0.127724913268733E+02 gamma(00000017)= 0.127724913268733E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 18 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.0E-13, # of iterations = 18 lr_apply_liouvillian: applying interaction: normal alpha(00000018)= 0.000000000000000E+00 beta (00000018)= 0.134686824774804E+02 gamma(00000018)= 0.134686824774804E+02 z1= 1 0.299382166150405E+00 0.000000000000000E+00 z1= 2 -0.456378442774755E-06 0.000000000000000E+00 z1= 3 0.708252964718055E-08 0.000000000000000E+00 Lanczos iteration: 19 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000019)= 0.000000000000000E+00 beta (00000019)= 0.126919513588791E+02 gamma(00000019)= 0.126919513588791E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 20 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.1E-13, # of iterations = 18 lr_apply_liouvillian: applying interaction: normal alpha(00000020)= 0.000000000000000E+00 beta (00000020)= 0.133778252205840E+02 gamma(00000020)= 0.133778252205840E+02 z1= 1 -0.284019243658253E+00 0.000000000000000E+00 z1= 2 0.456788224341073E-06 0.000000000000000E+00 z1= 3 -0.599411962697461E-08 0.000000000000000E+00 Lanczos iteration: 21 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000021)= 0.000000000000000E+00 beta (00000021)= 0.127277702615960E+02 gamma(00000021)= 0.127277702615960E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 22 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.4E-13, # of iterations = 18 lr_apply_liouvillian: applying interaction: normal alpha(00000022)= 0.000000000000000E+00 beta (00000022)= 0.134706305795693E+02 gamma(00000022)= 0.134706305795693E+02 z1= 1 0.268341760696981E+00 0.000000000000000E+00 z1= 2 -0.454912023663614E-06 0.000000000000000E+00 z1= 3 0.574554602744519E-08 0.000000000000000E+00 Lanczos iteration: 23 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000023)= 0.000000000000000E+00 beta (00000023)= 0.127895856605351E+02 gamma(00000023)= 0.127895856605351E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 24 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.6E-13, # of iterations = 17 lr_apply_liouvillian: applying interaction: normal alpha(00000024)= 0.000000000000000E+00 beta (00000024)= 0.134414480331259E+02 gamma(00000024)= 0.134414480331259E+02 z1= 1 -0.255310979118630E+00 0.000000000000000E+00 z1= 2 0.456758722757605E-06 0.000000000000000E+00 z1= 3 -0.639450125359056E-08 0.000000000000000E+00 Lanczos iteration: 25 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000025)= 0.000000000000000E+00 beta (00000025)= 0.128720199919477E+02 gamma(00000025)= 0.128720199919477E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 26 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.5E-13, # of iterations = 17 lr_apply_liouvillian: applying interaction: normal alpha(00000026)= 0.000000000000000E+00 beta (00000026)= 0.136147861148547E+02 gamma(00000026)= 0.136147861148547E+02 z1= 1 0.241362078277320E+00 0.000000000000000E+00 z1= 2 -0.456174912734711E-06 0.000000000000000E+00 z1= 3 0.683417957002361E-08 0.000000000000000E+00 Lanczos iteration: 27 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000027)= 0.000000000000000E+00 beta (00000027)= 0.129098261404445E+02 gamma(00000027)= 0.129098261404445E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 28 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.5E-13, # of iterations = 17 lr_apply_liouvillian: applying interaction: normal alpha(00000028)= 0.000000000000000E+00 beta (00000028)= 0.134503405509697E+02 gamma(00000028)= 0.134503405509697E+02 z1= 1 -0.231637789756933E+00 0.000000000000000E+00 z1= 2 0.463203032447651E-06 0.000000000000000E+00 z1= 3 -0.672999130079191E-08 0.000000000000000E+00 Lanczos iteration: 29 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000029)= 0.000000000000000E+00 beta (00000029)= 0.128064941290936E+02 gamma(00000029)= 0.128064941290936E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 30 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.5E-13, # of iterations = 17 lr_apply_liouvillian: applying interaction: normal alpha(00000030)= 0.000000000000000E+00 beta (00000030)= 0.134315394586008E+02 gamma(00000030)= 0.134315394586008E+02 z1= 1 0.220828347723291E+00 0.000000000000000E+00 z1= 2 -0.467699902073453E-06 0.000000000000000E+00 z1= 3 0.648420782627286E-08 0.000000000000000E+00 Lanczos iteration: 31 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000031)= 0.000000000000000E+00 beta (00000031)= 0.127433374812241E+02 gamma(00000031)= 0.127433374812241E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 32 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.7E-13, # of iterations = 17 lr_apply_liouvillian: applying interaction: normal alpha(00000032)= 0.000000000000000E+00 beta (00000032)= 0.133606707751040E+02 gamma(00000032)= 0.133606707751040E+02 z1= 1 -0.210589213500206E+00 0.000000000000000E+00 z1= 2 0.473352143743819E-06 0.000000000000000E+00 z1= 3 -0.586084854942420E-08 0.000000000000000E+00 Lanczos iteration: 33 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000033)= 0.000000000000000E+00 beta (00000033)= 0.126539890640914E+02 gamma(00000033)= 0.126539890640914E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 34 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.8E-13, # of iterations = 17 lr_apply_liouvillian: applying interaction: normal alpha(00000034)= 0.000000000000000E+00 beta (00000034)= 0.132882573815475E+02 gamma(00000034)= 0.132882573815475E+02 z1= 1 0.200495971233070E+00 0.000000000000000E+00 z1= 2 -0.478161255373574E-06 0.000000000000000E+00 z1= 3 0.431667993537610E-08 0.000000000000000E+00 Lanczos iteration: 35 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000035)= 0.000000000000000E+00 beta (00000035)= 0.128109616427714E+02 gamma(00000035)= 0.128109616427714E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 36 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 17 lr_apply_liouvillian: applying interaction: normal alpha(00000036)= 0.000000000000000E+00 beta (00000036)= 0.133259630718254E+02 gamma(00000036)= 0.133259630718254E+02 z1= 1 -0.192701806562437E+00 0.000000000000000E+00 z1= 2 0.484768242398764E-06 0.000000000000000E+00 z1= 3 -0.395378317401534E-08 0.000000000000000E+00 Lanczos iteration: 37 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000037)= 0.000000000000000E+00 beta (00000037)= 0.125858741951539E+02 gamma(00000037)= 0.125858741951539E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 38 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.2E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000038)= 0.000000000000000E+00 beta (00000038)= 0.135292392104309E+02 gamma(00000038)= 0.135292392104309E+02 z1= 1 0.179215345539990E+00 0.000000000000000E+00 z1= 2 -0.474832945593015E-06 0.000000000000000E+00 z1= 3 0.502672339397579E-08 0.000000000000000E+00 Lanczos iteration: 39 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000039)= 0.000000000000000E+00 beta (00000039)= 0.129363580649618E+02 gamma(00000039)= 0.129363580649618E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 40 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.0E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000040)= 0.000000000000000E+00 beta (00000040)= 0.132944715083416E+02 gamma(00000040)= 0.132944715083416E+02 z1= 1 -0.174333925970254E+00 0.000000000000000E+00 z1= 2 0.485544649724348E-06 0.000000000000000E+00 z1= 3 -0.641663279086178E-08 0.000000000000000E+00 Lanczos iteration: 41 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000041)= 0.000000000000000E+00 beta (00000041)= 0.126617402095952E+02 gamma(00000041)= 0.126617402095952E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 42 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.0E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000042)= 0.000000000000000E+00 beta (00000042)= 0.132829358954901E+02 gamma(00000042)= 0.132829358954901E+02 z1= 1 0.166124207292563E+00 0.000000000000000E+00 z1= 2 -0.485429218689826E-06 0.000000000000000E+00 z1= 3 0.786255458917057E-08 0.000000000000000E+00 Lanczos iteration: 43 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000043)= 0.000000000000000E+00 beta (00000043)= 0.127919678895934E+02 gamma(00000043)= 0.127919678895934E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 44 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.3E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000044)= 0.000000000000000E+00 beta (00000044)= 0.134450756531929E+02 gamma(00000044)= 0.134450756531929E+02 z1= 1 -0.157997316657101E+00 0.000000000000000E+00 z1= 2 0.484678027731431E-06 0.000000000000000E+00 z1= 3 -0.891429122792248E-08 0.000000000000000E+00 Lanczos iteration: 45 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000045)= 0.000000000000000E+00 beta (00000045)= 0.127158794650293E+02 gamma(00000045)= 0.127158794650293E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 46 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.6E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000046)= 0.000000000000000E+00 beta (00000046)= 0.133682122700477E+02 gamma(00000046)= 0.133682122700477E+02 z1= 1 0.150228496706278E+00 0.000000000000000E+00 z1= 2 -0.486261421779252E-06 0.000000000000000E+00 z1= 3 0.939353637257646E-08 0.000000000000000E+00 Lanczos iteration: 47 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000047)= 0.000000000000000E+00 beta (00000047)= 0.126050526538244E+02 gamma(00000047)= 0.126050526538244E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 48 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.0E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000048)= 0.000000000000000E+00 beta (00000048)= 0.132920662110732E+02 gamma(00000048)= 0.132920662110732E+02 z1= 1 -0.142403544800447E+00 0.000000000000000E+00 z1= 2 0.488068274641026E-06 0.000000000000000E+00 z1= 3 -0.962014567898288E-08 0.000000000000000E+00 Lanczos iteration: 49 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000049)= 0.000000000000000E+00 beta (00000049)= 0.126245805550807E+02 gamma(00000049)= 0.126245805550807E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 50 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.5E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000050)= 0.000000000000000E+00 beta (00000050)= 0.131105389785976E+02 gamma(00000050)= 0.131105389785976E+02 z1= 1 0.137064329245226E+00 0.000000000000000E+00 z1= 2 -0.497178637060350E-06 0.000000000000000E+00 z1= 3 0.959846946607494E-08 0.000000000000000E+00 Lanczos iteration: 51 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000051)= 0.000000000000000E+00 beta (00000051)= 0.126514689303591E+02 gamma(00000051)= 0.126514689303591E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 52 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000052)= 0.000000000000000E+00 beta (00000052)= 0.131546928905238E+02 gamma(00000052)= 0.131546928905238E+02 z1= 1 -0.131762518514147E+00 0.000000000000000E+00 z1= 2 0.504606983191269E-06 0.000000000000000E+00 z1= 3 -0.968687473767646E-08 0.000000000000000E+00 Lanczos iteration: 53 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000053)= 0.000000000000000E+00 beta (00000053)= 0.127236122806735E+02 gamma(00000053)= 0.127236122806735E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 54 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000054)= 0.000000000000000E+00 beta (00000054)= 0.132489652334010E+02 gamma(00000054)= 0.132489652334010E+02 z1= 1 0.126482303703000E+00 0.000000000000000E+00 z1= 2 -0.510362258692235E-06 0.000000000000000E+00 z1= 3 0.106734365228501E-07 0.000000000000000E+00 Lanczos iteration: 55 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000055)= 0.000000000000000E+00 beta (00000055)= 0.126569552804602E+02 gamma(00000055)= 0.126569552804602E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 56 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000056)= 0.000000000000000E+00 beta (00000056)= 0.134572426156789E+02 gamma(00000056)= 0.134572426156789E+02 z1= 1 -0.118908539454948E+00 0.000000000000000E+00 z1= 2 0.505410906015413E-06 0.000000000000000E+00 z1= 3 -0.120557404673354E-07 0.000000000000000E+00 Lanczos iteration: 57 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000057)= 0.000000000000000E+00 beta (00000057)= 0.127068713152273E+02 gamma(00000057)= 0.127068713152273E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 58 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000058)= 0.000000000000000E+00 beta (00000058)= 0.134315218890715E+02 gamma(00000058)= 0.134315218890715E+02 z1= 1 0.112442741794817E+00 0.000000000000000E+00 z1= 2 -0.503457263666823E-06 0.000000000000000E+00 z1= 3 0.124344648707361E-07 0.000000000000000E+00 Lanczos iteration: 59 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000059)= 0.000000000000000E+00 beta (00000059)= 0.127673298486303E+02 gamma(00000059)= 0.127673298486303E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 60 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000060)= 0.000000000000000E+00 beta (00000060)= 0.132464497340377E+02 gamma(00000060)= 0.132464497340377E+02 z1= 1 -0.108327929628749E+00 0.000000000000000E+00 z1= 2 0.510323395777612E-06 0.000000000000000E+00 z1= 3 -0.125892899546960E-07 0.000000000000000E+00 Lanczos iteration: 61 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000061)= 0.000000000000000E+00 beta (00000061)= 0.125205664644144E+02 gamma(00000061)= 0.125205664644144E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 62 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000062)= 0.000000000000000E+00 beta (00000062)= 0.133161515105480E+02 gamma(00000062)= 0.133161515105480E+02 z1= 1 0.101810160420062E+00 0.000000000000000E+00 z1= 2 -0.504364864449547E-06 0.000000000000000E+00 z1= 3 0.130144592932341E-07 0.000000000000000E+00 Lanczos iteration: 63 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000063)= 0.000000000000000E+00 beta (00000063)= 0.125430157442119E+02 gamma(00000063)= 0.125430157442119E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 64 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.7E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000064)= 0.000000000000000E+00 beta (00000064)= 0.131850899936075E+02 gamma(00000064)= 0.131850899936075E+02 z1= 1 -0.968100249202048E-01 0.000000000000000E+00 z1= 2 0.504193751985071E-06 0.000000000000000E+00 z1= 3 -0.133436199912813E-07 0.000000000000000E+00 Lanczos iteration: 65 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000065)= 0.000000000000000E+00 beta (00000065)= 0.126814838828622E+02 gamma(00000065)= 0.126814838828622E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 66 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000066)= 0.000000000000000E+00 beta (00000066)= 0.131033390142532E+02 gamma(00000066)= 0.131033390142532E+02 z1= 1 0.936531634936864E-01 0.000000000000000E+00 z1= 2 -0.511469521170121E-06 0.000000000000000E+00 z1= 3 0.133343336114564E-07 0.000000000000000E+00 Lanczos iteration: 67 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000067)= 0.000000000000000E+00 beta (00000067)= 0.128533761691824E+02 gamma(00000067)= 0.128533761691824E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 68 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000068)= 0.000000000000000E+00 beta (00000068)= 0.132983793076960E+02 gamma(00000068)= 0.132983793076960E+02 z1= 1 -0.904854548726303E-01 0.000000000000000E+00 z1= 2 0.516740912333974E-06 0.000000000000000E+00 z1= 3 -0.132663857525285E-07 0.000000000000000E+00 Lanczos iteration: 69 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000069)= 0.000000000000000E+00 beta (00000069)= 0.127670673099578E+02 gamma(00000069)= 0.127670673099578E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 70 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000070)= 0.000000000000000E+00 beta (00000070)= 0.130919758775763E+02 gamma(00000070)= 0.130919758775763E+02 z1= 1 0.882074740724319E-01 0.000000000000000E+00 z1= 2 -0.526694542159721E-06 0.000000000000000E+00 z1= 3 0.143455305137100E-07 0.000000000000000E+00 Lanczos iteration: 71 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000071)= 0.000000000000000E+00 beta (00000071)= 0.127418935055859E+02 gamma(00000071)= 0.127418935055859E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 72 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000072)= 0.000000000000000E+00 beta (00000072)= 0.133775442056506E+02 gamma(00000072)= 0.133775442056506E+02 z1= 1 -0.839908997463501E-01 0.000000000000000E+00 z1= 2 0.523356602665469E-06 0.000000000000000E+00 z1= 3 -0.152545511990405E-07 0.000000000000000E+00 Lanczos iteration: 73 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000073)= 0.000000000000000E+00 beta (00000073)= 0.126213895995329E+02 gamma(00000073)= 0.126213895995329E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 74 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000074)= 0.000000000000000E+00 beta (00000074)= 0.133181093481621E+02 gamma(00000074)= 0.133181093481621E+02 z1= 1 0.795714683619018E-01 0.000000000000000E+00 z1= 2 -0.518021947645657E-06 0.000000000000000E+00 z1= 3 0.158918522594892E-07 0.000000000000000E+00 Lanczos iteration: 75 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000075)= 0.000000000000000E+00 beta (00000075)= 0.129522721772642E+02 gamma(00000075)= 0.129522721772642E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 76 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000076)= 0.000000000000000E+00 beta (00000076)= 0.136072417051135E+02 gamma(00000076)= 0.136072417051135E+02 z1= 1 -0.757231479613658E-01 0.000000000000000E+00 z1= 2 0.513668185743443E-06 0.000000000000000E+00 z1= 3 -0.163917570792857E-07 0.000000000000000E+00 Lanczos iteration: 77 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000077)= 0.000000000000000E+00 beta (00000077)= 0.130542596737202E+02 gamma(00000077)= 0.130542596737202E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 78 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000078)= 0.000000000000000E+00 beta (00000078)= 0.134946630383056E+02 gamma(00000078)= 0.134946630383056E+02 z1= 1 0.732320245412287E-01 0.000000000000000E+00 z1= 2 -0.517212393909977E-06 0.000000000000000E+00 z1= 3 0.174271761539842E-07 0.000000000000000E+00 Lanczos iteration: 79 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000079)= 0.000000000000000E+00 beta (00000079)= 0.128475306554316E+02 gamma(00000079)= 0.128475306554316E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 80 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000080)= 0.000000000000000E+00 beta (00000080)= 0.135769044619669E+02 gamma(00000080)= 0.135769044619669E+02 z1= 1 -0.692854555011445E-01 0.000000000000000E+00 z1= 2 0.509427635965801E-06 0.000000000000000E+00 z1= 3 -0.186401555835568E-07 0.000000000000000E+00 Lanczos iteration: 81 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000081)= 0.000000000000000E+00 beta (00000081)= 0.127359399654003E+02 gamma(00000081)= 0.127359399654003E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 82 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000082)= 0.000000000000000E+00 beta (00000082)= 0.133647091447488E+02 gamma(00000082)= 0.133647091447488E+02 z1= 1 0.660115917661087E-01 0.000000000000000E+00 z1= 2 -0.506560775855383E-06 0.000000000000000E+00 z1= 3 0.200142145890224E-07 0.000000000000000E+00 Lanczos iteration: 83 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000083)= 0.000000000000000E+00 beta (00000083)= 0.126879913303875E+02 gamma(00000083)= 0.126879913303875E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 84 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000084)= 0.000000000000000E+00 beta (00000084)= 0.135878673505918E+02 gamma(00000084)= 0.135878673505918E+02 z1= 1 -0.616324257687730E-01 0.000000000000000E+00 z1= 2 0.493844533611728E-06 0.000000000000000E+00 z1= 3 -0.217985722601906E-07 0.000000000000000E+00 Lanczos iteration: 85 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000085)= 0.000000000000000E+00 beta (00000085)= 0.129027232388499E+02 gamma(00000085)= 0.129027232388499E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 86 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000086)= 0.000000000000000E+00 beta (00000086)= 0.134800182660832E+02 gamma(00000086)= 0.134800182660832E+02 z1= 1 0.589846780629739E-01 0.000000000000000E+00 z1= 2 -0.493380588249565E-06 0.000000000000000E+00 z1= 3 0.247338113328228E-07 0.000000000000000E+00 Lanczos iteration: 87 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000087)= 0.000000000000000E+00 beta (00000087)= 0.125464517735184E+02 gamma(00000087)= 0.125464517735184E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 88 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000088)= 0.000000000000000E+00 beta (00000088)= 0.131711323316381E+02 gamma(00000088)= 0.131711323316381E+02 z1= 1 -0.561835089634029E-01 0.000000000000000E+00 z1= 2 0.492660724557038E-06 0.000000000000000E+00 z1= 3 -0.271902791790148E-07 0.000000000000000E+00 Lanczos iteration: 89 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000089)= 0.000000000000000E+00 beta (00000089)= 0.127109081111075E+02 gamma(00000089)= 0.127109081111075E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 90 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000090)= 0.000000000000000E+00 beta (00000090)= 0.135664036925798E+02 gamma(00000090)= 0.135664036925798E+02 z1= 1 0.526367909931472E-01 0.000000000000000E+00 z1= 2 -0.484371316448323E-06 0.000000000000000E+00 z1= 3 0.281576559165407E-07 0.000000000000000E+00 Lanczos iteration: 91 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000091)= 0.000000000000000E+00 beta (00000091)= 0.126763947764569E+02 gamma(00000091)= 0.126763947764569E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 92 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000092)= 0.000000000000000E+00 beta (00000092)= 0.131206238060416E+02 gamma(00000092)= 0.131206238060416E+02 z1= 1 -0.508541170352896E-01 0.000000000000000E+00 z1= 2 0.493580004838276E-06 0.000000000000000E+00 z1= 3 -0.285570742300685E-07 0.000000000000000E+00 Lanczos iteration: 93 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000093)= 0.000000000000000E+00 beta (00000093)= 0.127417708234497E+02 gamma(00000093)= 0.127417708234497E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 94 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000094)= 0.000000000000000E+00 beta (00000094)= 0.131244074694068E+02 gamma(00000094)= 0.131244074694068E+02 z1= 1 0.493708848749312E-01 0.000000000000000E+00 z1= 2 -0.504705239903931E-06 0.000000000000000E+00 z1= 3 0.287140263606142E-07 0.000000000000000E+00 Lanczos iteration: 95 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000095)= 0.000000000000000E+00 beta (00000095)= 0.126167584767706E+02 gamma(00000095)= 0.126167584767706E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 96 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000096)= 0.000000000000000E+00 beta (00000096)= 0.130501900406091E+02 gamma(00000096)= 0.130501900406091E+02 z1= 1 -0.477325375382189E-01 0.000000000000000E+00 z1= 2 0.513027314354500E-06 0.000000000000000E+00 z1= 3 -0.287773155248881E-07 0.000000000000000E+00 Lanczos iteration: 97 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000097)= 0.000000000000000E+00 beta (00000097)= 0.129305772323556E+02 gamma(00000097)= 0.129305772323556E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 98 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000098)= 0.000000000000000E+00 beta (00000098)= 0.130694891861398E+02 gamma(00000098)= 0.130694891861398E+02 z1= 1 0.472264513128543E-01 0.000000000000000E+00 z1= 2 -0.532002723355532E-06 0.000000000000000E+00 z1= 3 0.292801398352888E-07 0.000000000000000E+00 Lanczos iteration: 99 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000099)= 0.000000000000000E+00 beta (00000099)= 0.128250186086222E+02 gamma(00000099)= 0.128250186086222E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 100 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000100)= 0.000000000000000E+00 beta (00000100)= 0.132936066541267E+02 gamma(00000100)= 0.132936066541267E+02 z1= 1 -0.455638001677971E-01 0.000000000000000E+00 z1= 2 0.536571879011793E-06 0.000000000000000E+00 z1= 3 -0.291975601478429E-07 0.000000000000000E+00 Lanczos iteration: 101 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000101)= 0.000000000000000E+00 beta (00000101)= 0.127825656030896E+02 gamma(00000101)= 0.127825656030896E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 102 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000102)= 0.000000000000000E+00 beta (00000102)= 0.129699895509049E+02 gamma(00000102)= 0.129699895509049E+02 z1= 1 0.449078785291694E-01 0.000000000000000E+00 z1= 2 -0.552831465460736E-06 0.000000000000000E+00 z1= 3 0.287623157504621E-07 0.000000000000000E+00 Lanczos iteration: 103 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000103)= 0.000000000000000E+00 beta (00000103)= 0.126639018643551E+02 gamma(00000103)= 0.126639018643551E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 104 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000104)= 0.000000000000000E+00 beta (00000104)= 0.135222526222151E+02 gamma(00000104)= 0.135222526222151E+02 z1= 1 -0.420596685426642E-01 0.000000000000000E+00 z1= 2 0.539329050694599E-06 0.000000000000000E+00 z1= 3 -0.275056150642397E-07 0.000000000000000E+00 Lanczos iteration: 105 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000105)= 0.000000000000000E+00 beta (00000105)= 0.129400862585780E+02 gamma(00000105)= 0.129400862585780E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 106 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000106)= 0.000000000000000E+00 beta (00000106)= 0.132777627412193E+02 gamma(00000106)= 0.132777627412193E+02 z1= 1 0.409935199894291E-01 0.000000000000000E+00 z1= 2 -0.546697783186841E-06 0.000000000000000E+00 z1= 3 0.284220973150069E-07 0.000000000000000E+00 Lanczos iteration: 107 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000107)= 0.000000000000000E+00 beta (00000107)= 0.127551190047524E+02 gamma(00000107)= 0.127551190047524E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 108 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000108)= 0.000000000000000E+00 beta (00000108)= 0.134610360677736E+02 gamma(00000108)= 0.134610360677736E+02 z1= 1 -0.388469518911958E-01 0.000000000000000E+00 z1= 2 0.538636863268299E-06 0.000000000000000E+00 z1= 3 -0.288108232106635E-07 0.000000000000000E+00 Lanczos iteration: 109 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000109)= 0.000000000000000E+00 beta (00000109)= 0.130004319955596E+02 gamma(00000109)= 0.130004319955596E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 110 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000110)= 0.000000000000000E+00 beta (00000110)= 0.134801491929313E+02 gamma(00000110)= 0.134801491929313E+02 z1= 1 0.374699750688730E-01 0.000000000000000E+00 z1= 2 -0.539877834816911E-06 0.000000000000000E+00 z1= 3 0.301341128044509E-07 0.000000000000000E+00 Lanczos iteration: 111 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000111)= 0.000000000000000E+00 beta (00000111)= 0.126592417351548E+02 gamma(00000111)= 0.126592417351548E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 112 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000112)= 0.000000000000000E+00 beta (00000112)= 0.132260735190269E+02 gamma(00000112)= 0.132260735190269E+02 z1= 1 -0.358690704271012E-01 0.000000000000000E+00 z1= 2 0.537661885354791E-06 0.000000000000000E+00 z1= 3 -0.309233351924142E-07 0.000000000000000E+00 Lanczos iteration: 113 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000113)= 0.000000000000000E+00 beta (00000113)= 0.125787413156707E+02 gamma(00000113)= 0.125787413156707E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 114 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000114)= 0.000000000000000E+00 beta (00000114)= 0.130416113994876E+02 gamma(00000114)= 0.130416113994876E+02 z1= 1 0.346039786455130E-01 0.000000000000000E+00 z1= 2 -0.539303828986197E-06 0.000000000000000E+00 z1= 3 0.316951417622408E-07 0.000000000000000E+00 Lanczos iteration: 115 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000115)= 0.000000000000000E+00 beta (00000115)= 0.124651408837767E+02 gamma(00000115)= 0.124651408837767E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 116 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000116)= 0.000000000000000E+00 beta (00000116)= 0.133127274193904E+02 gamma(00000116)= 0.133127274193904E+02 z1= 1 -0.324065694532806E-01 0.000000000000000E+00 z1= 2 0.524763778654048E-06 0.000000000000000E+00 z1= 3 -0.319024168408521E-07 0.000000000000000E+00 Lanczos iteration: 117 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000117)= 0.000000000000000E+00 beta (00000117)= 0.129165479807746E+02 gamma(00000117)= 0.129165479807746E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 118 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000118)= 0.000000000000000E+00 beta (00000118)= 0.133529934776605E+02 gamma(00000118)= 0.133529934776605E+02 z1= 1 0.313564363579050E-01 0.000000000000000E+00 z1= 2 -0.525876861689513E-06 0.000000000000000E+00 z1= 3 0.333700654693483E-07 0.000000000000000E+00 Lanczos iteration: 119 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000119)= 0.000000000000000E+00 beta (00000119)= 0.129231238079293E+02 gamma(00000119)= 0.129231238079293E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 120 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000120)= 0.000000000000000E+00 beta (00000120)= 0.133421834182222E+02 gamma(00000120)= 0.133421834182222E+02 z1= 1 -0.303765473089928E-01 0.000000000000000E+00 z1= 2 0.526525136352197E-06 0.000000000000000E+00 z1= 3 -0.354889005782337E-07 0.000000000000000E+00 Lanczos iteration: 121 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000121)= 0.000000000000000E+00 beta (00000121)= 0.130723286970537E+02 gamma(00000121)= 0.130723286970537E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 122 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000122)= 0.000000000000000E+00 beta (00000122)= 0.138308531690102E+02 gamma(00000122)= 0.138308531690102E+02 z1= 1 0.287204516789531E-01 0.000000000000000E+00 z1= 2 -0.512996327931437E-06 0.000000000000000E+00 z1= 3 0.356108828096242E-07 0.000000000000000E+00 Lanczos iteration: 123 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000123)= 0.000000000000000E+00 beta (00000123)= 0.126092670004036E+02 gamma(00000123)= 0.126092670004036E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 124 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000124)= 0.000000000000000E+00 beta (00000124)= 0.133723414597874E+02 gamma(00000124)= 0.133723414597874E+02 z1= 1 -0.270867195948911E-01 0.000000000000000E+00 z1= 2 0.499545904874416E-06 0.000000000000000E+00 z1= 3 -0.347532864574014E-07 0.000000000000000E+00 Lanczos iteration: 125 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000125)= 0.000000000000000E+00 beta (00000125)= 0.129909481377437E+02 gamma(00000125)= 0.129909481377437E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 126 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000126)= 0.000000000000000E+00 beta (00000126)= 0.136629570541354E+02 gamma(00000126)= 0.136629570541354E+02 z1= 1 0.257643855743783E-01 0.000000000000000E+00 z1= 2 -0.491180416655173E-06 0.000000000000000E+00 z1= 3 0.339808196509524E-07 0.000000000000000E+00 Lanczos iteration: 127 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000127)= 0.000000000000000E+00 beta (00000127)= 0.125949649267931E+02 gamma(00000127)= 0.125949649267931E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 128 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.7E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000128)= 0.000000000000000E+00 beta (00000128)= 0.132210251693630E+02 gamma(00000128)= 0.132210251693630E+02 z1= 1 -0.245498843226473E-01 0.000000000000000E+00 z1= 2 0.487311969632389E-06 0.000000000000000E+00 z1= 3 -0.330968453806507E-07 0.000000000000000E+00 Lanczos iteration: 129 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000129)= 0.000000000000000E+00 beta (00000129)= 0.126762646868082E+02 gamma(00000129)= 0.126762646868082E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 130 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000130)= 0.000000000000000E+00 beta (00000130)= 0.134394378789397E+02 gamma(00000130)= 0.134394378789397E+02 z1= 1 0.231652230364697E-01 0.000000000000000E+00 z1= 2 -0.479384274352200E-06 0.000000000000000E+00 z1= 3 0.322945216588676E-07 0.000000000000000E+00 Lanczos iteration: 131 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000131)= 0.000000000000000E+00 beta (00000131)= 0.129683537429057E+02 gamma(00000131)= 0.129683537429057E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 132 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000132)= 0.000000000000000E+00 beta (00000132)= 0.133084828349409E+02 gamma(00000132)= 0.133084828349409E+02 z1= 1 -0.225787959586415E-01 0.000000000000000E+00 z1= 2 0.486935303118871E-06 0.000000000000000E+00 z1= 3 -0.322596682260107E-07 0.000000000000000E+00 Lanczos iteration: 133 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000133)= 0.000000000000000E+00 beta (00000133)= 0.126237316142372E+02 gamma(00000133)= 0.126237316142372E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 134 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000134)= 0.000000000000000E+00 beta (00000134)= 0.133179053224482E+02 gamma(00000134)= 0.133179053224482E+02 z1= 1 0.214110224705450E-01 0.000000000000000E+00 z1= 2 -0.481999343993067E-06 0.000000000000000E+00 z1= 3 0.310897144829674E-07 0.000000000000000E+00 Lanczos iteration: 135 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000135)= 0.000000000000000E+00 beta (00000135)= 0.126289526599831E+02 gamma(00000135)= 0.126289526599831E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 136 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000136)= 0.000000000000000E+00 beta (00000136)= 0.134393053592814E+02 gamma(00000136)= 0.134393053592814E+02 z1= 1 -0.201267437910976E-01 0.000000000000000E+00 z1= 2 0.473557696743787E-06 0.000000000000000E+00 z1= 3 -0.307848848508365E-07 0.000000000000000E+00 Lanczos iteration: 137 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000137)= 0.000000000000000E+00 beta (00000137)= 0.129299225366621E+02 gamma(00000137)= 0.129299225366621E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 138 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000138)= 0.000000000000000E+00 beta (00000138)= 0.132395563246516E+02 gamma(00000138)= 0.132395563246516E+02 z1= 1 0.196652410232406E-01 0.000000000000000E+00 z1= 2 -0.483288665773483E-06 0.000000000000000E+00 z1= 3 0.318748078717047E-07 0.000000000000000E+00 Lanczos iteration: 139 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000139)= 0.000000000000000E+00 beta (00000139)= 0.128022809220352E+02 gamma(00000139)= 0.128022809220352E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 140 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000140)= 0.000000000000000E+00 beta (00000140)= 0.135041935023156E+02 gamma(00000140)= 0.135041935023156E+02 z1= 1 -0.186505797730495E-01 0.000000000000000E+00 z1= 2 0.477294684003357E-06 0.000000000000000E+00 z1= 3 -0.317134165178645E-07 0.000000000000000E+00 Lanczos iteration: 141 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000141)= 0.000000000000000E+00 beta (00000141)= 0.123992243998144E+02 gamma(00000141)= 0.123992243998144E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 142 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.7E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000142)= 0.000000000000000E+00 beta (00000142)= 0.132323175381174E+02 gamma(00000142)= 0.132323175381174E+02 z1= 1 0.174862228129008E-01 0.000000000000000E+00 z1= 2 -0.466926366465489E-06 0.000000000000000E+00 z1= 3 0.321780569691957E-07 0.000000000000000E+00 Lanczos iteration: 143 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000143)= 0.000000000000000E+00 beta (00000143)= 0.127233603118691E+02 gamma(00000143)= 0.127233603118691E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 144 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000144)= 0.000000000000000E+00 beta (00000144)= 0.133308985955093E+02 gamma(00000144)= 0.133308985955093E+02 z1= 1 -0.166986699538680E-01 0.000000000000000E+00 z1= 2 0.466060299033309E-06 0.000000000000000E+00 z1= 3 -0.336282402577538E-07 0.000000000000000E+00 Lanczos iteration: 145 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000145)= 0.000000000000000E+00 beta (00000145)= 0.125952668020311E+02 gamma(00000145)= 0.125952668020311E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 146 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000146)= 0.000000000000000E+00 beta (00000146)= 0.131254507796407E+02 gamma(00000146)= 0.131254507796407E+02 z1= 1 0.160345161359690E-01 0.000000000000000E+00 z1= 2 -0.469321148798430E-06 0.000000000000000E+00 z1= 3 0.348608797807581E-07 0.000000000000000E+00 Lanczos iteration: 147 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000147)= 0.000000000000000E+00 beta (00000147)= 0.122693154876520E+02 gamma(00000147)= 0.122693154876520E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 148 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.7E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000148)= 0.000000000000000E+00 beta (00000148)= 0.136721771805870E+02 gamma(00000148)= 0.136721771805870E+02 z1= 1 -0.143990622743401E-01 0.000000000000000E+00 z1= 2 0.442188546736621E-06 0.000000000000000E+00 z1= 3 -0.336786537253166E-07 0.000000000000000E+00 Lanczos iteration: 149 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000149)= 0.000000000000000E+00 beta (00000149)= 0.127424728852312E+02 gamma(00000149)= 0.127424728852312E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 150 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000150)= 0.000000000000000E+00 beta (00000150)= 0.128121055481874E+02 gamma(00000150)= 0.128121055481874E+02 z1= 1 0.143317652968293E-01 0.000000000000000E+00 z1= 2 -0.462294922347947E-06 0.000000000000000E+00 z1= 3 0.358842203371495E-07 0.000000000000000E+00 Lanczos iteration: 151 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000151)= 0.000000000000000E+00 beta (00000151)= 0.129240510627961E+02 gamma(00000151)= 0.129240510627961E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 152 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000152)= 0.000000000000000E+00 beta (00000152)= 0.135196706235049E+02 gamma(00000152)= 0.135196706235049E+02 z1= 1 -0.137102266118230E-01 0.000000000000000E+00 z1= 2 0.463203968908629E-06 0.000000000000000E+00 z1= 3 -0.358855107058945E-07 0.000000000000000E+00 Lanczos iteration: 153 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000153)= 0.000000000000000E+00 beta (00000153)= 0.124271480547685E+02 gamma(00000153)= 0.124271480547685E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 154 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000154)= 0.000000000000000E+00 beta (00000154)= 0.132349562344713E+02 gamma(00000154)= 0.132349562344713E+02 z1= 1 0.128835276347810E-01 0.000000000000000E+00 z1= 2 -0.458225289092125E-06 0.000000000000000E+00 z1= 3 0.348748855737570E-07 0.000000000000000E+00 Lanczos iteration: 155 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000155)= 0.000000000000000E+00 beta (00000155)= 0.126019346155951E+02 gamma(00000155)= 0.126019346155951E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 156 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000156)= 0.000000000000000E+00 beta (00000156)= 0.131294093993753E+02 gamma(00000156)= 0.131294093993753E+02 z1= 1 -0.123771209546533E-01 0.000000000000000E+00 z1= 2 0.463179173803641E-06 0.000000000000000E+00 z1= 3 -0.354968314469233E-07 0.000000000000000E+00 Lanczos iteration: 157 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000157)= 0.000000000000000E+00 beta (00000157)= 0.125730220810385E+02 gamma(00000157)= 0.125730220810385E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 158 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000158)= 0.000000000000000E+00 beta (00000158)= 0.130732552868149E+02 gamma(00000158)= 0.130732552868149E+02 z1= 1 0.119140137782323E-01 0.000000000000000E+00 z1= 2 -0.468290260704357E-06 0.000000000000000E+00 z1= 3 0.364974305176995E-07 0.000000000000000E+00 Lanczos iteration: 159 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000159)= 0.000000000000000E+00 beta (00000159)= 0.128978780713425E+02 gamma(00000159)= 0.128978780713425E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 160 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000160)= 0.000000000000000E+00 beta (00000160)= 0.129100149589869E+02 gamma(00000160)= 0.129100149589869E+02 z1= 1 -0.119152089582526E-01 0.000000000000000E+00 z1= 2 0.490376369317782E-06 0.000000000000000E+00 z1= 3 -0.379446328643753E-07 0.000000000000000E+00 Lanczos iteration: 161 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000161)= 0.000000000000000E+00 beta (00000161)= 0.127630279797986E+02 gamma(00000161)= 0.127630279797986E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 162 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000162)= 0.000000000000000E+00 beta (00000162)= 0.131500217477145E+02 gamma(00000162)= 0.131500217477145E+02 z1= 1 0.115739825367108E-01 0.000000000000000E+00 z1= 2 -0.496133938740419E-06 0.000000000000000E+00 z1= 3 0.379555171771813E-07 0.000000000000000E+00 Lanczos iteration: 163 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000163)= 0.000000000000000E+00 beta (00000163)= 0.128823639806984E+02 gamma(00000163)= 0.128823639806984E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 164 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000164)= 0.000000000000000E+00 beta (00000164)= 0.134169539447324E+02 gamma(00000164)= 0.134169539447324E+02 z1= 1 -0.111256439345206E-01 0.000000000000000E+00 z1= 2 0.495777654535914E-06 0.000000000000000E+00 z1= 3 -0.374405080407701E-07 0.000000000000000E+00 Lanczos iteration: 165 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000165)= 0.000000000000000E+00 beta (00000165)= 0.124885798134945E+02 gamma(00000165)= 0.124885798134945E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 166 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000166)= 0.000000000000000E+00 beta (00000166)= 0.134111519367737E+02 gamma(00000166)= 0.134111519367737E+02 z1= 1 0.103689752939722E-01 0.000000000000000E+00 z1= 2 -0.481232256406474E-06 0.000000000000000E+00 z1= 3 0.355938900097161E-07 0.000000000000000E+00 Lanczos iteration: 167 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000167)= 0.000000000000000E+00 beta (00000167)= 0.125627923144720E+02 gamma(00000167)= 0.125627923144720E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 168 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000168)= 0.000000000000000E+00 beta (00000168)= 0.132703956292541E+02 gamma(00000168)= 0.132703956292541E+02 z1= 1 -0.983039204992498E-02 0.000000000000000E+00 z1= 2 0.475861837213572E-06 0.000000000000000E+00 z1= 3 -0.346736896452413E-07 0.000000000000000E+00 Lanczos iteration: 169 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000169)= 0.000000000000000E+00 beta (00000169)= 0.128533723187984E+02 gamma(00000169)= 0.128533723187984E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 170 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000170)= 0.000000000000000E+00 beta (00000170)= 0.137433338815777E+02 gamma(00000170)= 0.137433338815777E+02 z1= 1 0.920009155030554E-02 0.000000000000000E+00 z1= 2 -0.465139873143290E-06 0.000000000000000E+00 z1= 3 0.349643680323092E-07 0.000000000000000E+00 Lanczos iteration: 171 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000171)= 0.000000000000000E+00 beta (00000171)= 0.125742258069402E+02 gamma(00000171)= 0.125742258069402E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 172 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.7E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000172)= 0.000000000000000E+00 beta (00000172)= 0.132348531918128E+02 gamma(00000172)= 0.132348531918128E+02 z1= 1 -0.875612822374490E-02 0.000000000000000E+00 z1= 2 0.463889934370146E-06 0.000000000000000E+00 z1= 3 -0.368949980767601E-07 0.000000000000000E+00 Lanczos iteration: 173 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000173)= 0.000000000000000E+00 beta (00000173)= 0.129770024576906E+02 gamma(00000173)= 0.129770024576906E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 174 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000174)= 0.000000000000000E+00 beta (00000174)= 0.132145075123829E+02 gamma(00000174)= 0.132145075123829E+02 z1= 1 0.860283013077590E-02 0.000000000000000E+00 z1= 2 -0.476119686947107E-06 0.000000000000000E+00 z1= 3 0.403862241885153E-07 0.000000000000000E+00 Lanczos iteration: 175 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000175)= 0.000000000000000E+00 beta (00000175)= 0.129294032702487E+02 gamma(00000175)= 0.129294032702487E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 176 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000176)= 0.000000000000000E+00 beta (00000176)= 0.133047810437306E+02 gamma(00000176)= 0.133047810437306E+02 z1= 1 -0.837392002183480E-02 0.000000000000000E+00 z1= 2 0.482161168228502E-06 0.000000000000000E+00 z1= 3 -0.433907618605585E-07 0.000000000000000E+00 Lanczos iteration: 177 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000177)= 0.000000000000000E+00 beta (00000177)= 0.127261244956577E+02 gamma(00000177)= 0.127261244956577E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 178 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000178)= 0.000000000000000E+00 beta (00000178)= 0.129213708074553E+02 gamma(00000178)= 0.129213708074553E+02 z1= 1 0.824731777176429E-02 0.000000000000000E+00 z1= 2 -0.495546970220515E-06 0.000000000000000E+00 z1= 3 0.470222481403770E-07 0.000000000000000E+00 Lanczos iteration: 179 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000179)= 0.000000000000000E+00 beta (00000179)= 0.130863701639356E+02 gamma(00000179)= 0.130863701639356E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 180 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000180)= 0.000000000000000E+00 beta (00000180)= 0.132719926566052E+02 gamma(00000180)= 0.132719926566052E+02 z1= 1 -0.814446866628039E-02 0.000000000000000E+00 z1= 2 0.508113891520973E-06 0.000000000000000E+00 z1= 3 -0.488796467707853E-07 0.000000000000000E+00 Lanczos iteration: 181 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000181)= 0.000000000000000E+00 beta (00000181)= 0.129054048951945E+02 gamma(00000181)= 0.129054048951945E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 182 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000182)= 0.000000000000000E+00 beta (00000182)= 0.134702964511738E+02 gamma(00000182)= 0.134702964511738E+02 z1= 1 0.779711060221545E-02 0.000000000000000E+00 z1= 2 -0.506408215745005E-06 0.000000000000000E+00 z1= 3 0.493837125713323E-07 0.000000000000000E+00 Lanczos iteration: 183 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000183)= 0.000000000000000E+00 beta (00000183)= 0.127831659176393E+02 gamma(00000183)= 0.127831659176393E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 184 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000184)= 0.000000000000000E+00 beta (00000184)= 0.134151229391575E+02 gamma(00000184)= 0.134151229391575E+02 z1= 1 -0.744059815868100E-02 0.000000000000000E+00 z1= 2 0.503085711860141E-06 0.000000000000000E+00 z1= 3 -0.489212002510600E-07 0.000000000000000E+00 Lanczos iteration: 185 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000185)= 0.000000000000000E+00 beta (00000185)= 0.133785948838796E+02 gamma(00000185)= 0.133785948838796E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 186 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000186)= 0.000000000000000E+00 beta (00000186)= 0.130149095200110E+02 gamma(00000186)= 0.130149095200110E+02 z1= 1 0.763933080586307E-02 0.000000000000000E+00 z1= 2 -0.536210217904481E-06 0.000000000000000E+00 z1= 3 0.526519767201218E-07 0.000000000000000E+00 Lanczos iteration: 187 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000187)= 0.000000000000000E+00 beta (00000187)= 0.128147374406728E+02 gamma(00000187)= 0.128147374406728E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 188 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000188)= 0.000000000000000E+00 beta (00000188)= 0.133730090332435E+02 gamma(00000188)= 0.133730090332435E+02 z1= 1 -0.732832894159955E-02 0.000000000000000E+00 z1= 2 0.532388900222058E-06 0.000000000000000E+00 z1= 3 -0.514132252337515E-07 0.000000000000000E+00 Lanczos iteration: 189 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000189)= 0.000000000000000E+00 beta (00000189)= 0.125372267458563E+02 gamma(00000189)= 0.125372267458563E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 190 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000190)= 0.000000000000000E+00 beta (00000190)= 0.134861839057571E+02 gamma(00000190)= 0.134861839057571E+02 z1= 1 0.680222878094017E-02 0.000000000000000E+00 z1= 2 -0.512274929065012E-06 0.000000000000000E+00 z1= 3 0.491722363054714E-07 0.000000000000000E+00 Lanczos iteration: 191 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000191)= 0.000000000000000E+00 beta (00000191)= 0.129531596770252E+02 gamma(00000191)= 0.129531596770252E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 192 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000192)= 0.000000000000000E+00 beta (00000192)= 0.131339341744631E+02 gamma(00000192)= 0.131339341744631E+02 z1= 1 -0.671426268178872E-02 0.000000000000000E+00 z1= 2 0.523919346785001E-06 0.000000000000000E+00 z1= 3 -0.501940380130076E-07 0.000000000000000E+00 Lanczos iteration: 193 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000193)= 0.000000000000000E+00 beta (00000193)= 0.132315043011409E+02 gamma(00000193)= 0.132315043011409E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 194 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000194)= 0.000000000000000E+00 beta (00000194)= 0.135653591943548E+02 gamma(00000194)= 0.135653591943548E+02 z1= 1 0.653812681543170E-02 0.000000000000000E+00 z1= 2 -0.529656806719236E-06 0.000000000000000E+00 z1= 3 0.514839811036104E-07 0.000000000000000E+00 Lanczos iteration: 195 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000195)= 0.000000000000000E+00 beta (00000195)= 0.127110333243458E+02 gamma(00000195)= 0.127110333243458E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 196 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000196)= 0.000000000000000E+00 beta (00000196)= 0.139186372838971E+02 gamma(00000196)= 0.139186372838971E+02 z1= 1 -0.597453218807107E-02 0.000000000000000E+00 z1= 2 0.503595383075095E-06 0.000000000000000E+00 z1= 3 -0.488388100353164E-07 0.000000000000000E+00 Lanczos iteration: 197 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000197)= 0.000000000000000E+00 beta (00000197)= 0.119716641422512E+02 gamma(00000197)= 0.119716641422512E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 198 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.6E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000198)= 0.000000000000000E+00 beta (00000198)= 0.138616079364107E+02 gamma(00000198)= 0.138616079364107E+02 z1= 1 0.515203434105561E-02 0.000000000000000E+00 z1= 2 -0.456711320330136E-06 0.000000000000000E+00 z1= 3 0.452577491511278E-07 0.000000000000000E+00 Lanczos iteration: 199 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000199)= 0.000000000000000E+00 beta (00000199)= 0.122226540298476E+02 gamma(00000199)= 0.122226540298476E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 200 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.8E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000200)= 0.000000000000000E+00 beta (00000200)= 0.135898954633440E+02 gamma(00000200)= 0.135898954633440E+02 z1= 1 -0.463451711400987E-02 0.000000000000000E+00 z1= 2 0.434618273667184E-06 0.000000000000000E+00 z1= 3 -0.436540286876796E-07 0.000000000000000E+00 Lanczos iteration: 201 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000201)= 0.000000000000000E+00 beta (00000201)= 0.124827095515063E+02 gamma(00000201)= 0.124827095515063E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 202 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.5E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000202)= 0.000000000000000E+00 beta (00000202)= 0.131802621776543E+02 gamma(00000202)= 0.131802621776543E+02 z1= 1 0.438311637760483E-02 0.000000000000000E+00 z1= 2 -0.437861315148377E-06 0.000000000000000E+00 z1= 3 0.448485794789710E-07 0.000000000000000E+00 Lanczos iteration: 203 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000203)= 0.000000000000000E+00 beta (00000203)= 0.128773131879308E+02 gamma(00000203)= 0.128773131879308E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 204 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000204)= 0.000000000000000E+00 beta (00000204)= 0.131000784485565E+02 gamma(00000204)= 0.131000784485565E+02 z1= 1 -0.430844503060716E-02 0.000000000000000E+00 z1= 2 0.456672643989360E-06 0.000000000000000E+00 z1= 3 -0.465550210846126E-07 0.000000000000000E+00 Lanczos iteration: 205 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000205)= 0.000000000000000E+00 beta (00000205)= 0.125951223034559E+02 gamma(00000205)= 0.125951223034559E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 206 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000206)= 0.000000000000000E+00 beta (00000206)= 0.130223117949871E+02 gamma(00000206)= 0.130223117949871E+02 z1= 1 0.416474265482676E-02 0.000000000000000E+00 z1= 2 -0.467575008463242E-06 0.000000000000000E+00 z1= 3 0.465919312901903E-07 0.000000000000000E+00 Lanczos iteration: 207 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000207)= 0.000000000000000E+00 beta (00000207)= 0.127204231052374E+02 gamma(00000207)= 0.127204231052374E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 208 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000208)= 0.000000000000000E+00 beta (00000208)= 0.132745450948231E+02 gamma(00000208)= 0.132745450948231E+02 z1= 1 -0.399244820687662E-02 0.000000000000000E+00 z1= 2 0.472123787063558E-06 0.000000000000000E+00 z1= 3 -0.460219747185867E-07 0.000000000000000E+00 Lanczos iteration: 209 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000209)= 0.000000000000000E+00 beta (00000209)= 0.123805938289879E+02 gamma(00000209)= 0.123805938289879E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 210 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000210)= 0.000000000000000E+00 beta (00000210)= 0.129190513082487E+02 gamma(00000210)= 0.129190513082487E+02 z1= 1 0.382716300307767E-02 0.000000000000000E+00 z1= 2 -0.478157348257624E-06 0.000000000000000E+00 z1= 3 0.462060175512912E-07 0.000000000000000E+00 Lanczos iteration: 211 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000211)= 0.000000000000000E+00 beta (00000211)= 0.126808050269071E+02 gamma(00000211)= 0.126808050269071E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 212 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000212)= 0.000000000000000E+00 beta (00000212)= 0.133848256821675E+02 gamma(00000212)= 0.133848256821675E+02 z1= 1 -0.362943865533647E-02 0.000000000000000E+00 z1= 2 0.476809918494372E-06 0.000000000000000E+00 z1= 3 -0.455948579698251E-07 0.000000000000000E+00 Lanczos iteration: 213 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000213)= 0.000000000000000E+00 beta (00000213)= 0.124456270109341E+02 gamma(00000213)= 0.124456270109341E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 214 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000214)= 0.000000000000000E+00 beta (00000214)= 0.131277584406919E+02 gamma(00000214)= 0.131277584406919E+02 z1= 1 0.344428749559273E-02 0.000000000000000E+00 z1= 2 -0.475655300396192E-06 0.000000000000000E+00 z1= 3 0.450361441770649E-07 0.000000000000000E+00 Lanczos iteration: 215 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000215)= 0.000000000000000E+00 beta (00000215)= 0.126955665193866E+02 gamma(00000215)= 0.126955665193866E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 216 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000216)= 0.000000000000000E+00 beta (00000216)= 0.137084320299558E+02 gamma(00000216)= 0.137084320299558E+02 z1= 1 -0.319482784587619E-02 0.000000000000000E+00 z1= 2 0.461392662995212E-06 0.000000000000000E+00 z1= 3 -0.438125312341082E-07 0.000000000000000E+00 Lanczos iteration: 217 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000217)= 0.000000000000000E+00 beta (00000217)= 0.129679729328628E+02 gamma(00000217)= 0.129679729328628E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 218 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000218)= 0.000000000000000E+00 beta (00000218)= 0.134105106492235E+02 gamma(00000218)= 0.134105106492235E+02 z1= 1 0.309363001911150E-02 0.000000000000000E+00 z1= 2 -0.467195297277137E-06 0.000000000000000E+00 z1= 3 0.442384410290078E-07 0.000000000000000E+00 Lanczos iteration: 219 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000219)= 0.000000000000000E+00 beta (00000219)= 0.125094580831953E+02 gamma(00000219)= 0.125094580831953E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 220 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000220)= 0.000000000000000E+00 beta (00000220)= 0.133534848667369E+02 gamma(00000220)= 0.133534848667369E+02 z1= 1 -0.290392723502507E-02 0.000000000000000E+00 z1= 2 0.459949221216782E-06 0.000000000000000E+00 z1= 3 -0.427035981855842E-07 0.000000000000000E+00 Lanczos iteration: 221 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000221)= 0.000000000000000E+00 beta (00000221)= 0.126732642451544E+02 gamma(00000221)= 0.126732642451544E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 222 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000222)= 0.000000000000000E+00 beta (00000222)= 0.132759000777614E+02 gamma(00000222)= 0.132759000777614E+02 z1= 1 0.277687140028771E-02 0.000000000000000E+00 z1= 2 -0.462172441588471E-06 0.000000000000000E+00 z1= 3 0.419987791948698E-07 0.000000000000000E+00 Lanczos iteration: 223 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000223)= 0.000000000000000E+00 beta (00000223)= 0.124717640048838E+02 gamma(00000223)= 0.124717640048838E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 224 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000224)= 0.000000000000000E+00 beta (00000224)= 0.135248486937062E+02 gamma(00000224)= 0.135248486937062E+02 z1= 1 -0.256686543167560E-02 0.000000000000000E+00 z1= 2 0.448029880289330E-06 0.000000000000000E+00 z1= 3 -0.402106943250304E-07 0.000000000000000E+00 Lanczos iteration: 225 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000225)= 0.000000000000000E+00 beta (00000225)= 0.127989317707482E+02 gamma(00000225)= 0.127989317707482E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 226 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000226)= 0.000000000000000E+00 beta (00000226)= 0.132563023501131E+02 gamma(00000226)= 0.132563023501131E+02 z1= 1 0.248354736797835E-02 0.000000000000000E+00 z1= 2 -0.452201476324951E-06 0.000000000000000E+00 z1= 3 0.402467485529929E-07 0.000000000000000E+00 Lanczos iteration: 227 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000227)= 0.000000000000000E+00 beta (00000227)= 0.121704374358966E+02 gamma(00000227)= 0.121704374358966E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 228 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000228)= 0.000000000000000E+00 beta (00000228)= 0.133980392219114E+02 gamma(00000228)= 0.133980392219114E+02 z1= 1 -0.226192922576656E-02 0.000000000000000E+00 z1= 2 0.428322366741174E-06 0.000000000000000E+00 z1= 3 -0.370881902992878E-07 0.000000000000000E+00 Lanczos iteration: 229 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000229)= 0.000000000000000E+00 beta (00000229)= 0.128288378272319E+02 gamma(00000229)= 0.128288378272319E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 230 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000230)= 0.000000000000000E+00 beta (00000230)= 0.133144277338104E+02 gamma(00000230)= 0.133144277338104E+02 z1= 1 0.218441523186749E-02 0.000000000000000E+00 z1= 2 -0.429631598681049E-06 0.000000000000000E+00 z1= 3 0.362546958140517E-07 0.000000000000000E+00 Lanczos iteration: 231 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000231)= 0.000000000000000E+00 beta (00000231)= 0.126018760656488E+02 gamma(00000231)= 0.126018760656488E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 232 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000232)= 0.000000000000000E+00 beta (00000232)= 0.138146141608256E+02 gamma(00000232)= 0.138146141608256E+02 z1= 1 -0.199618897847219E-02 0.000000000000000E+00 z1= 2 0.409268540385935E-06 0.000000000000000E+00 z1= 3 -0.328708952362054E-07 0.000000000000000E+00 Lanczos iteration: 233 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000233)= 0.000000000000000E+00 beta (00000233)= 0.130317411225988E+02 gamma(00000233)= 0.130317411225988E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 234 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000234)= 0.000000000000000E+00 beta (00000234)= 0.136720505571134E+02 gamma(00000234)= 0.136720505571134E+02 z1= 1 0.190627003511923E-02 0.000000000000000E+00 z1= 2 -0.406795187072109E-06 0.000000000000000E+00 z1= 3 0.315056516344420E-07 0.000000000000000E+00 Lanczos iteration: 235 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000235)= 0.000000000000000E+00 beta (00000235)= 0.129334197551557E+02 gamma(00000235)= 0.129334197551557E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 236 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.4E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000236)= 0.000000000000000E+00 beta (00000236)= 0.133542637731445E+02 gamma(00000236)= 0.133542637731445E+02 z1= 1 -0.184763291933796E-02 0.000000000000000E+00 z1= 2 0.409635500573866E-06 0.000000000000000E+00 z1= 3 -0.297130754681619E-07 0.000000000000000E+00 Lanczos iteration: 237 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000237)= 0.000000000000000E+00 beta (00000237)= 0.126966113350686E+02 gamma(00000237)= 0.126966113350686E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 238 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.4E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000238)= 0.000000000000000E+00 beta (00000238)= 0.136537195704279E+02 gamma(00000238)= 0.136537195704279E+02 z1= 1 0.171964873495826E-02 0.000000000000000E+00 z1= 2 -0.396576929668699E-06 0.000000000000000E+00 z1= 3 0.272657206090276E-07 0.000000000000000E+00 Lanczos iteration: 239 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000239)= 0.000000000000000E+00 beta (00000239)= 0.130073310910547E+02 gamma(00000239)= 0.130073310910547E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 240 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.7E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000240)= 0.000000000000000E+00 beta (00000240)= 0.130840648516561E+02 gamma(00000240)= 0.130840648516561E+02 z1= 1 -0.170808940569965E-02 0.000000000000000E+00 z1= 2 0.410917428944613E-06 0.000000000000000E+00 z1= 3 -0.275701988110104E-07 0.000000000000000E+00 Lanczos iteration: 241 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000241)= 0.000000000000000E+00 beta (00000241)= 0.124579701720839E+02 gamma(00000241)= 0.124579701720839E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 242 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.4E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000242)= 0.000000000000000E+00 beta (00000242)= 0.133028396842699E+02 gamma(00000242)= 0.133028396842699E+02 z1= 1 0.159877851326556E-02 0.000000000000000E+00 z1= 2 -0.399829240311719E-06 0.000000000000000E+00 z1= 3 0.278258158415909E-07 0.000000000000000E+00 Lanczos iteration: 243 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000243)= 0.000000000000000E+00 beta (00000243)= 0.126349095077876E+02 gamma(00000243)= 0.126349095077876E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 244 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.7E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000244)= 0.000000000000000E+00 beta (00000244)= 0.133265008069497E+02 gamma(00000244)= 0.133265008069497E+02 z1= 1 -0.151184462158116E-02 0.000000000000000E+00 z1= 2 0.392052778318275E-06 0.000000000000000E+00 z1= 3 -0.279257014209992E-07 0.000000000000000E+00 Lanczos iteration: 245 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000245)= 0.000000000000000E+00 beta (00000245)= 0.128796233568719E+02 gamma(00000245)= 0.128796233568719E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 246 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000246)= 0.000000000000000E+00 beta (00000246)= 0.135454346364827E+02 gamma(00000246)= 0.135454346364827E+02 z1= 1 0.143464015807960E-02 0.000000000000000E+00 z1= 2 -0.383288484185826E-06 0.000000000000000E+00 z1= 3 0.275730262576206E-07 0.000000000000000E+00 Lanczos iteration: 247 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000247)= 0.000000000000000E+00 beta (00000247)= 0.128870407496683E+02 gamma(00000247)= 0.128870407496683E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 248 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000248)= 0.000000000000000E+00 beta (00000248)= 0.131514311174885E+02 gamma(00000248)= 0.131514311174885E+02 z1= 1 -0.139925554680443E-02 0.000000000000000E+00 z1= 2 0.386120450437608E-06 0.000000000000000E+00 z1= 3 -0.271447270514067E-07 0.000000000000000E+00 Lanczos iteration: 249 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000249)= 0.000000000000000E+00 beta (00000249)= 0.127341546474687E+02 gamma(00000249)= 0.127341546474687E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 250 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000250)= 0.000000000000000E+00 beta (00000250)= 0.135614137330705E+02 gamma(00000250)= 0.135614137330705E+02 z1= 1 0.130895655686862E-02 0.000000000000000E+00 z1= 2 -0.372185527496363E-06 0.000000000000000E+00 z1= 3 0.261339378278182E-07 0.000000000000000E+00 Lanczos iteration: 251 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000251)= 0.000000000000000E+00 beta (00000251)= 0.125569735280219E+02 gamma(00000251)= 0.125569735280219E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 252 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000252)= 0.000000000000000E+00 beta (00000252)= 0.131792424403993E+02 gamma(00000252)= 0.131792424403993E+02 z1= 1 -0.123781396880571E-02 0.000000000000000E+00 z1= 2 0.363631455628857E-06 0.000000000000000E+00 z1= 3 -0.251031029734929E-07 0.000000000000000E+00 Lanczos iteration: 253 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000253)= 0.000000000000000E+00 beta (00000253)= 0.129206069555509E+02 gamma(00000253)= 0.129206069555509E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 254 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000254)= 0.000000000000000E+00 beta (00000254)= 0.133357080113027E+02 gamma(00000254)= 0.133357080113027E+02 z1= 1 0.119071436909877E-02 0.000000000000000E+00 z1= 2 -0.359058111980629E-06 0.000000000000000E+00 z1= 3 0.263598393809242E-07 0.000000000000000E+00 Lanczos iteration: 255 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000255)= 0.000000000000000E+00 beta (00000255)= 0.128066055108490E+02 gamma(00000255)= 0.128066055108490E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 256 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000256)= 0.000000000000000E+00 beta (00000256)= 0.136597224490884E+02 gamma(00000256)= 0.136597224490884E+02 z1= 1 -0.110396510372038E-02 0.000000000000000E+00 z1= 2 0.343038394969367E-06 0.000000000000000E+00 z1= 3 -0.279871021072924E-07 0.000000000000000E+00 Lanczos iteration: 257 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000257)= 0.000000000000000E+00 beta (00000257)= 0.125704848417426E+02 gamma(00000257)= 0.125704848417426E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 258 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.5E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000258)= 0.000000000000000E+00 beta (00000258)= 0.131199118574702E+02 gamma(00000258)= 0.131199118574702E+02 z1= 1 0.104485398973571E-02 0.000000000000000E+00 z1= 2 -0.336474992389257E-06 0.000000000000000E+00 z1= 3 0.307699721566017E-07 0.000000000000000E+00 Lanczos iteration: 259 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000259)= 0.000000000000000E+00 beta (00000259)= 0.124011077374471E+02 gamma(00000259)= 0.124011077374471E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 260 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.5E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000260)= 0.000000000000000E+00 beta (00000260)= 0.132971514431064E+02 gamma(00000260)= 0.132971514431064E+02 z1= 1 -0.958238499276537E-03 0.000000000000000E+00 z1= 2 0.320827037708984E-06 0.000000000000000E+00 z1= 3 -0.321550465138924E-07 0.000000000000000E+00 Lanczos iteration: 261 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000261)= 0.000000000000000E+00 beta (00000261)= 0.127730711330695E+02 gamma(00000261)= 0.127730711330695E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 262 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.6E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000262)= 0.000000000000000E+00 beta (00000262)= 0.132798086980287E+02 gamma(00000262)= 0.132798086980287E+02 z1= 1 0.906422942058331E-03 0.000000000000000E+00 z1= 2 -0.313814227187459E-06 0.000000000000000E+00 z1= 3 0.332987026493709E-07 0.000000000000000E+00 Lanczos iteration: 263 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000263)= 0.000000000000000E+00 beta (00000263)= 0.126525177584917E+02 gamma(00000263)= 0.126525177584917E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 264 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.9E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000264)= 0.000000000000000E+00 beta (00000264)= 0.136137361336834E+02 gamma(00000264)= 0.136137361336834E+02 z1= 1 -0.825295081623555E-03 0.000000000000000E+00 z1= 2 0.297429150994052E-06 0.000000000000000E+00 z1= 3 -0.320636828641738E-07 0.000000000000000E+00 Lanczos iteration: 265 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000265)= 0.000000000000000E+00 beta (00000265)= 0.127956467561568E+02 gamma(00000265)= 0.127956467561568E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 266 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.0E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000266)= 0.000000000000000E+00 beta (00000266)= 0.132562300654214E+02 gamma(00000266)= 0.132562300654214E+02 z1= 1 0.780095532760969E-03 0.000000000000000E+00 z1= 2 -0.293194343159789E-06 0.000000000000000E+00 z1= 3 0.321839404856345E-07 0.000000000000000E+00 Lanczos iteration: 267 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000267)= 0.000000000000000E+00 beta (00000267)= 0.121816210400209E+02 gamma(00000267)= 0.121816210400209E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 268 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.8E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000268)= 0.000000000000000E+00 beta (00000268)= 0.130493727781707E+02 gamma(00000268)= 0.130493727781707E+02 z1= 1 -0.708868558158261E-03 0.000000000000000E+00 z1= 2 0.280487458768734E-06 0.000000000000000E+00 z1= 3 -0.313168601550305E-07 0.000000000000000E+00 Lanczos iteration: 269 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000269)= 0.000000000000000E+00 beta (00000269)= 0.126889922533201E+02 gamma(00000269)= 0.126889922533201E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 270 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.5E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000270)= 0.000000000000000E+00 beta (00000270)= 0.132863271228222E+02 gamma(00000270)= 0.132863271228222E+02 z1= 1 0.661521771421369E-03 0.000000000000000E+00 z1= 2 -0.274875145315351E-06 0.000000000000000E+00 z1= 3 0.302182700994075E-07 0.000000000000000E+00 Lanczos iteration: 271 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000271)= 0.000000000000000E+00 beta (00000271)= 0.125021784396760E+02 gamma(00000271)= 0.125021784396760E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 272 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000272)= 0.000000000000000E+00 beta (00000272)= 0.134831558100605E+02 gamma(00000272)= 0.134831558100605E+02 z1= 1 -0.594548580528121E-03 0.000000000000000E+00 z1= 2 0.263677582317424E-06 0.000000000000000E+00 z1= 3 -0.278297251376548E-07 0.000000000000000E+00 Lanczos iteration: 273 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000273)= 0.000000000000000E+00 beta (00000273)= 0.127019573457749E+02 gamma(00000273)= 0.127019573457749E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 274 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000274)= 0.000000000000000E+00 beta (00000274)= 0.128550891195205E+02 gamma(00000274)= 0.128550891195205E+02 z1= 1 0.573828098334483E-03 0.000000000000000E+00 z1= 2 -0.270366476357638E-06 0.000000000000000E+00 z1= 3 0.286220122946513E-07 0.000000000000000E+00 Lanczos iteration: 275 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000275)= 0.000000000000000E+00 beta (00000275)= 0.130646932756814E+02 gamma(00000275)= 0.130646932756814E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 276 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000276)= 0.000000000000000E+00 beta (00000276)= 0.128779942043643E+02 gamma(00000276)= 0.128779942043643E+02 z1= 1 -0.563816989692774E-03 0.000000000000000E+00 z1= 2 0.285436632115922E-06 0.000000000000000E+00 z1= 3 -0.301633615077367E-07 0.000000000000000E+00 Lanczos iteration: 277 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000277)= 0.000000000000000E+00 beta (00000277)= 0.124224614772470E+02 gamma(00000277)= 0.124224614772470E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 278 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000278)= 0.000000000000000E+00 beta (00000278)= 0.135504058718201E+02 gamma(00000278)= 0.135504058718201E+02 z1= 1 0.510827557577469E-03 0.000000000000000E+00 z1= 2 -0.273496702046967E-06 0.000000000000000E+00 z1= 3 0.289327020097088E-07 0.000000000000000E+00 Lanczos iteration: 279 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000279)= 0.000000000000000E+00 beta (00000279)= 0.123029935611978E+02 gamma(00000279)= 0.123029935611978E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 280 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000280)= 0.000000000000000E+00 beta (00000280)= 0.134863890961986E+02 gamma(00000280)= 0.134863890961986E+02 z1= 1 -0.448429352944492E-03 0.000000000000000E+00 z1= 2 0.263445829991327E-06 0.000000000000000E+00 z1= 3 -0.288634997110864E-07 0.000000000000000E+00 Lanczos iteration: 281 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000281)= 0.000000000000000E+00 beta (00000281)= 0.130778249284525E+02 gamma(00000281)= 0.130778249284525E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 282 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000282)= 0.000000000000000E+00 beta (00000282)= 0.136188003168563E+02 gamma(00000282)= 0.136188003168563E+02 z1= 1 0.431399137256521E-03 0.000000000000000E+00 z1= 2 -0.267320626092492E-06 0.000000000000000E+00 z1= 3 0.308012318631220E-07 0.000000000000000E+00 Lanczos iteration: 283 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000283)= 0.000000000000000E+00 beta (00000283)= 0.130416840264159E+02 gamma(00000283)= 0.130416840264159E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 284 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.7E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000284)= 0.000000000000000E+00 beta (00000284)= 0.133006671510862E+02 gamma(00000284)= 0.133006671510862E+02 z1= 1 -0.405809718227287E-03 0.000000000000000E+00 z1= 2 0.278784419549538E-06 0.000000000000000E+00 z1= 3 -0.334724421530846E-07 0.000000000000000E+00 Lanczos iteration: 285 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000285)= 0.000000000000000E+00 beta (00000285)= 0.126712319448552E+02 gamma(00000285)= 0.126712319448552E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 286 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000286)= 0.000000000000000E+00 beta (00000286)= 0.136988354151588E+02 gamma(00000286)= 0.136988354151588E+02 z1= 1 0.380056409629521E-03 0.000000000000000E+00 z1= 2 -0.272882071813974E-06 0.000000000000000E+00 z1= 3 0.332268884100555E-07 0.000000000000000E+00 Lanczos iteration: 287 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000287)= 0.000000000000000E+00 beta (00000287)= 0.123645751595464E+02 gamma(00000287)= 0.123645751595464E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 288 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000288)= 0.000000000000000E+00 beta (00000288)= 0.137990138000196E+02 gamma(00000288)= 0.137990138000196E+02 z1= 1 -0.326752533409657E-03 0.000000000000000E+00 z1= 2 0.261143262304461E-06 0.000000000000000E+00 z1= 3 -0.309735238776532E-07 0.000000000000000E+00 Lanczos iteration: 289 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000289)= 0.000000000000000E+00 beta (00000289)= 0.128376642808558E+02 gamma(00000289)= 0.128376642808558E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 290 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.4E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000290)= 0.000000000000000E+00 beta (00000290)= 0.132656016837626E+02 gamma(00000290)= 0.132656016837626E+02 z1= 1 0.323348314454637E-03 0.000000000000000E+00 z1= 2 -0.267256138027430E-06 0.000000000000000E+00 z1= 3 0.309422848877698E-07 0.000000000000000E+00 Lanczos iteration: 291 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000291)= 0.000000000000000E+00 beta (00000291)= 0.131213396482652E+02 gamma(00000291)= 0.131213396482652E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 292 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.6E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000292)= 0.000000000000000E+00 beta (00000292)= 0.133875664477362E+02 gamma(00000292)= 0.133875664477362E+02 z1= 1 -0.306399524583102E-03 0.000000000000000E+00 z1= 2 0.276250568904610E-06 0.000000000000000E+00 z1= 3 -0.315161624937825E-07 0.000000000000000E+00 Lanczos iteration: 293 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000293)= 0.000000000000000E+00 beta (00000293)= 0.123756750984102E+02 gamma(00000293)= 0.123756750984102E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 294 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.2E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000294)= 0.000000000000000E+00 beta (00000294)= 0.136517144510890E+02 gamma(00000294)= 0.136517144510890E+02 z1= 1 0.285791357812527E-03 0.000000000000000E+00 z1= 2 -0.263861104427693E-06 0.000000000000000E+00 z1= 3 0.302101231156688E-07 0.000000000000000E+00 Lanczos iteration: 295 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000295)= 0.000000000000000E+00 beta (00000295)= 0.126581595053155E+02 gamma(00000295)= 0.126581595053155E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 296 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.8E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000296)= 0.000000000000000E+00 beta (00000296)= 0.135638052127303E+02 gamma(00000296)= 0.135638052127303E+02 z1= 1 -0.260365830092075E-03 0.000000000000000E+00 z1= 2 0.261733539241166E-06 0.000000000000000E+00 z1= 3 -0.301123154361786E-07 0.000000000000000E+00 Lanczos iteration: 297 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000297)= 0.000000000000000E+00 beta (00000297)= 0.131901266367170E+02 gamma(00000297)= 0.131901266367170E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 298 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000298)= 0.000000000000000E+00 beta (00000298)= 0.131222522811413E+02 gamma(00000298)= 0.131222522811413E+02 z1= 1 0.269885622746577E-03 0.000000000000000E+00 z1= 2 -0.278468472898752E-06 0.000000000000000E+00 z1= 3 0.329710525093056E-07 0.000000000000000E+00 Lanczos iteration: 299 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000299)= 0.000000000000000E+00 beta (00000299)= 0.129073003400625E+02 gamma(00000299)= 0.129073003400625E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 300 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000300)= 0.000000000000000E+00 beta (00000300)= 0.129072974209723E+02 gamma(00000300)= 0.129072974209723E+02 z1= 1 -0.268799853856453E-03 0.000000000000000E+00 z1= 2 0.294791318525972E-06 0.000000000000000E+00 z1= 3 -0.359943754279276E-07 0.000000000000000E+00 Lanczos iteration: 301 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000301)= 0.000000000000000E+00 beta (00000301)= 0.129078634371283E+02 gamma(00000301)= 0.129078634371283E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 302 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000302)= 0.000000000000000E+00 beta (00000302)= 0.129700423423368E+02 gamma(00000302)= 0.129700423423368E+02 z1= 1 0.276305823421866E-03 0.000000000000000E+00 z1= 2 -0.308619429598839E-06 0.000000000000000E+00 z1= 3 0.389563520905665E-07 0.000000000000000E+00 Lanczos iteration: 303 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000303)= 0.000000000000000E+00 beta (00000303)= 0.123952965487821E+02 gamma(00000303)= 0.123952965487821E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 304 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000304)= 0.000000000000000E+00 beta (00000304)= 0.134435015196854E+02 gamma(00000304)= 0.134435015196854E+02 z1= 1 -0.259782717394914E-03 0.000000000000000E+00 z1= 2 0.299481972960286E-06 0.000000000000000E+00 z1= 3 -0.392539444329367E-07 0.000000000000000E+00 Lanczos iteration: 305 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000305)= 0.000000000000000E+00 beta (00000305)= 0.128209414533776E+02 gamma(00000305)= 0.128209414533776E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 306 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000306)= 0.000000000000000E+00 beta (00000306)= 0.130838878451886E+02 gamma(00000306)= 0.130838878451886E+02 z1= 1 0.265642803090254E-03 0.000000000000000E+00 z1= 2 -0.306884004305785E-06 0.000000000000000E+00 z1= 3 0.423917028670928E-07 0.000000000000000E+00 Lanczos iteration: 307 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000307)= 0.000000000000000E+00 beta (00000307)= 0.126539842488772E+02 gamma(00000307)= 0.126539842488772E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 308 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.7E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000308)= 0.000000000000000E+00 beta (00000308)= 0.133764520688345E+02 gamma(00000308)= 0.133764520688345E+02 z1= 1 -0.259823248142579E-03 0.000000000000000E+00 z1= 2 0.303450951684089E-06 0.000000000000000E+00 z1= 3 -0.432502141175725E-07 0.000000000000000E+00 Lanczos iteration: 309 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000309)= 0.000000000000000E+00 beta (00000309)= 0.126728762841217E+02 gamma(00000309)= 0.126728762841217E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 310 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000310)= 0.000000000000000E+00 beta (00000310)= 0.134248062955507E+02 gamma(00000310)= 0.134248062955507E+02 z1= 1 0.256977934839982E-03 0.000000000000000E+00 z1= 2 -0.299419756960573E-06 0.000000000000000E+00 z1= 3 0.445201660648317E-07 0.000000000000000E+00 Lanczos iteration: 311 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000311)= 0.000000000000000E+00 beta (00000311)= 0.124223465577276E+02 gamma(00000311)= 0.124223465577276E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 312 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.3E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000312)= 0.000000000000000E+00 beta (00000312)= 0.134670232427892E+02 gamma(00000312)= 0.134670232427892E+02 z1= 1 -0.248317223518080E-03 0.000000000000000E+00 z1= 2 0.290950708109472E-06 0.000000000000000E+00 z1= 3 -0.438543426359425E-07 0.000000000000000E+00 Lanczos iteration: 313 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000313)= 0.000000000000000E+00 beta (00000313)= 0.129851919572448E+02 gamma(00000313)= 0.129851919572448E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 314 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.4E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000314)= 0.000000000000000E+00 beta (00000314)= 0.133806612498279E+02 gamma(00000314)= 0.133806612498279E+02 z1= 1 0.254025924727907E-03 0.000000000000000E+00 z1= 2 -0.297014458673639E-06 0.000000000000000E+00 z1= 3 0.460647611059484E-07 0.000000000000000E+00 Lanczos iteration: 315 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000315)= 0.000000000000000E+00 beta (00000315)= 0.128244275599117E+02 gamma(00000315)= 0.128244275599117E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 316 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.4E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000316)= 0.000000000000000E+00 beta (00000316)= 0.135296768588731E+02 gamma(00000316)= 0.135296768588731E+02 z1= 1 -0.254639739912712E-03 0.000000000000000E+00 z1= 2 0.295979751120494E-06 0.000000000000000E+00 z1= 3 -0.463409049848706E-07 0.000000000000000E+00 Lanczos iteration: 317 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000317)= 0.000000000000000E+00 beta (00000317)= 0.125397397401898E+02 gamma(00000317)= 0.125397397401898E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 318 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.3E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000318)= 0.000000000000000E+00 beta (00000318)= 0.130734075713943E+02 gamma(00000318)= 0.130734075713943E+02 z1= 1 0.258894386650103E-03 0.000000000000000E+00 z1= 2 -0.299095555321080E-06 0.000000000000000E+00 z1= 3 0.474697793695746E-07 0.000000000000000E+00 Lanczos iteration: 319 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000319)= 0.000000000000000E+00 beta (00000319)= 0.121740942379180E+02 gamma(00000319)= 0.121740942379180E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 320 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000320)= 0.000000000000000E+00 beta (00000320)= 0.133207456562252E+02 gamma(00000320)= 0.133207456562252E+02 z1= 1 -0.255772135361043E-03 0.000000000000000E+00 z1= 2 0.289950437099788E-06 0.000000000000000E+00 z1= 3 -0.443977116130340E-07 0.000000000000000E+00 Lanczos iteration: 321 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000321)= 0.000000000000000E+00 beta (00000321)= 0.125328794796815E+02 gamma(00000321)= 0.125328794796815E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 322 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.1E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000322)= 0.000000000000000E+00 beta (00000322)= 0.134875286587971E+02 gamma(00000322)= 0.134875286587971E+02 z1= 1 0.253576159163844E-03 0.000000000000000E+00 z1= 2 -0.284182274588353E-06 0.000000000000000E+00 z1= 3 0.439629682041183E-07 0.000000000000000E+00 Lanczos iteration: 323 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000323)= 0.000000000000000E+00 beta (00000323)= 0.126350054306541E+02 gamma(00000323)= 0.126350054306541E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 324 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.1E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000324)= 0.000000000000000E+00 beta (00000324)= 0.132959511266714E+02 gamma(00000324)= 0.132959511266714E+02 z1= 1 -0.266959253212084E-03 0.000000000000000E+00 z1= 2 0.284923774553081E-06 0.000000000000000E+00 z1= 3 -0.435641481657091E-07 0.000000000000000E+00 Lanczos iteration: 325 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000325)= 0.000000000000000E+00 beta (00000325)= 0.126786841461506E+02 gamma(00000325)= 0.126786841461506E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 326 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000326)= 0.000000000000000E+00 beta (00000326)= 0.135699040968559E+02 gamma(00000326)= 0.135699040968559E+02 z1= 1 0.265429779057231E-03 0.000000000000000E+00 z1= 2 -0.276694426036214E-06 0.000000000000000E+00 z1= 3 0.456982866206415E-07 0.000000000000000E+00 Lanczos iteration: 327 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000327)= 0.000000000000000E+00 beta (00000327)= 0.126413445180511E+02 gamma(00000327)= 0.126413445180511E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 328 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000328)= 0.000000000000000E+00 beta (00000328)= 0.132477880652073E+02 gamma(00000328)= 0.132477880652073E+02 z1= 1 -0.287560834990553E-03 0.000000000000000E+00 z1= 2 0.276105901887529E-06 0.000000000000000E+00 z1= 3 -0.466662192087804E-07 0.000000000000000E+00 Lanczos iteration: 329 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000329)= 0.000000000000000E+00 beta (00000329)= 0.124536434290029E+02 gamma(00000329)= 0.124536434290029E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 330 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000330)= 0.000000000000000E+00 beta (00000330)= 0.134732043595236E+02 gamma(00000330)= 0.134732043595236E+02 z1= 1 0.282303417584539E-03 0.000000000000000E+00 z1= 2 -0.262490457141051E-06 0.000000000000000E+00 z1= 3 0.494842777497501E-07 0.000000000000000E+00 Lanczos iteration: 331 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000331)= 0.000000000000000E+00 beta (00000331)= 0.129160262052761E+02 gamma(00000331)= 0.129160262052761E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 332 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.0E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000332)= 0.000000000000000E+00 beta (00000332)= 0.134153325961087E+02 gamma(00000332)= 0.134153325961087E+02 z1= 1 -0.313933349846359E-03 0.000000000000000E+00 z1= 2 0.262454237223361E-06 0.000000000000000E+00 z1= 3 -0.495209310105802E-07 0.000000000000000E+00 Lanczos iteration: 333 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000333)= 0.000000000000000E+00 beta (00000333)= 0.131687450077788E+02 gamma(00000333)= 0.131687450077788E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 334 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.7E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000334)= 0.000000000000000E+00 beta (00000334)= 0.133883445226579E+02 gamma(00000334)= 0.133883445226579E+02 z1= 1 0.320698924042306E-03 0.000000000000000E+00 z1= 2 -0.263578627607980E-06 0.000000000000000E+00 z1= 3 0.552370748519359E-07 0.000000000000000E+00 Lanczos iteration: 335 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000335)= 0.000000000000000E+00 beta (00000335)= 0.124019466048809E+02 gamma(00000335)= 0.124019466048809E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 336 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000336)= 0.000000000000000E+00 beta (00000336)= 0.129877035011271E+02 gamma(00000336)= 0.129877035011271E+02 z1= 1 -0.351734023926908E-03 0.000000000000000E+00 z1= 2 0.259510290616036E-06 0.000000000000000E+00 z1= 3 -0.537836206309164E-07 0.000000000000000E+00 Lanczos iteration: 337 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000337)= 0.000000000000000E+00 beta (00000337)= 0.126220570113666E+02 gamma(00000337)= 0.126220570113666E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 338 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000338)= 0.000000000000000E+00 beta (00000338)= 0.135909541271665E+02 gamma(00000338)= 0.135909541271665E+02 z1= 1 0.332011291029215E-03 0.000000000000000E+00 z1= 2 -0.241579094516914E-06 0.000000000000000E+00 z1= 3 0.573173509039408E-07 0.000000000000000E+00 Lanczos iteration: 339 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000339)= 0.000000000000000E+00 beta (00000339)= 0.124348058264936E+02 gamma(00000339)= 0.124348058264936E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 340 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000340)= 0.000000000000000E+00 beta (00000340)= 0.134234237916383E+02 gamma(00000340)= 0.134234237916383E+02 z1= 1 -0.358768202987905E-03 0.000000000000000E+00 z1= 2 0.228737306585264E-06 0.000000000000000E+00 z1= 3 -0.529683553081089E-07 0.000000000000000E+00 Lanczos iteration: 341 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000341)= 0.000000000000000E+00 beta (00000341)= 0.127741639072012E+02 gamma(00000341)= 0.127741639072012E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 342 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000342)= 0.000000000000000E+00 beta (00000342)= 0.134430609331292E+02 gamma(00000342)= 0.134430609331292E+02 z1= 1 0.333273835814081E-03 0.000000000000000E+00 z1= 2 -0.214221485514074E-06 0.000000000000000E+00 z1= 3 0.608583056939567E-07 0.000000000000000E+00 Lanczos iteration: 343 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000343)= 0.000000000000000E+00 beta (00000343)= 0.124268961157832E+02 gamma(00000343)= 0.124268961157832E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 344 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000344)= 0.000000000000000E+00 beta (00000344)= 0.138308187746164E+02 gamma(00000344)= 0.138308187746164E+02 z1= 1 -0.357612135025314E-03 0.000000000000000E+00 z1= 2 0.196255920521804E-06 0.000000000000000E+00 z1= 3 -0.540201413501591E-07 0.000000000000000E+00 Lanczos iteration: 345 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000345)= 0.000000000000000E+00 beta (00000345)= 0.130374459647696E+02 gamma(00000345)= 0.130374459647696E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 346 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000346)= 0.000000000000000E+00 beta (00000346)= 0.136619189170330E+02 gamma(00000346)= 0.136619189170330E+02 z1= 1 0.319327878403060E-03 0.000000000000000E+00 z1= 2 -0.180512953657647E-06 0.000000000000000E+00 z1= 3 0.640402501527436E-07 0.000000000000000E+00 Lanczos iteration: 347 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000347)= 0.000000000000000E+00 beta (00000347)= 0.126952873517150E+02 gamma(00000347)= 0.126952873517150E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 348 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000348)= 0.000000000000000E+00 beta (00000348)= 0.136501131456592E+02 gamma(00000348)= 0.136501131456592E+02 z1= 1 -0.354860174131208E-03 0.000000000000000E+00 z1= 2 0.169218486969352E-06 0.000000000000000E+00 z1= 3 -0.588996002970788E-07 0.000000000000000E+00 Lanczos iteration: 349 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000349)= 0.000000000000000E+00 beta (00000349)= 0.129398485495674E+02 gamma(00000349)= 0.129398485495674E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 350 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000350)= 0.000000000000000E+00 beta (00000350)= 0.133042867830909E+02 gamma(00000350)= 0.133042867830909E+02 z1= 1 0.326614376333943E-03 0.000000000000000E+00 z1= 2 -0.155738166165292E-06 0.000000000000000E+00 z1= 3 0.692377369287782E-07 0.000000000000000E+00 Lanczos iteration: 351 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000351)= 0.000000000000000E+00 beta (00000351)= 0.126895435438122E+02 gamma(00000351)= 0.126895435438122E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 352 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.2E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000352)= 0.000000000000000E+00 beta (00000352)= 0.131166606670020E+02 gamma(00000352)= 0.131166606670020E+02 z1= 1 -0.361040097968836E-03 0.000000000000000E+00 z1= 2 0.149605584134557E-06 0.000000000000000E+00 z1= 3 -0.675180210386872E-07 0.000000000000000E+00 Lanczos iteration: 353 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000353)= 0.000000000000000E+00 beta (00000353)= 0.131365204412434E+02 gamma(00000353)= 0.131365204412434E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 354 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000354)= 0.000000000000000E+00 beta (00000354)= 0.131768026844805E+02 gamma(00000354)= 0.131768026844805E+02 z1= 1 0.348492376545287E-03 0.000000000000000E+00 z1= 2 -0.141766280997366E-06 0.000000000000000E+00 z1= 3 0.766053584353669E-07 0.000000000000000E+00 Lanczos iteration: 355 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000355)= 0.000000000000000E+00 beta (00000355)= 0.126606055110486E+02 gamma(00000355)= 0.126606055110486E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 356 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000356)= 0.000000000000000E+00 beta (00000356)= 0.134015703825544E+02 gamma(00000356)= 0.134015703825544E+02 z1= 1 -0.357468050403967E-03 0.000000000000000E+00 z1= 2 0.133532872126016E-06 0.000000000000000E+00 z1= 3 -0.741339451972457E-07 0.000000000000000E+00 Lanczos iteration: 357 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000357)= 0.000000000000000E+00 beta (00000357)= 0.126672230236655E+02 gamma(00000357)= 0.126672230236655E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 358 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000358)= 0.000000000000000E+00 beta (00000358)= 0.134009199850160E+02 gamma(00000358)= 0.134009199850160E+02 z1= 1 0.331446897364052E-03 0.000000000000000E+00 z1= 2 -0.121512702816462E-06 0.000000000000000E+00 z1= 3 0.784355295797758E-07 0.000000000000000E+00 Lanczos iteration: 359 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000359)= 0.000000000000000E+00 beta (00000359)= 0.125905998096571E+02 gamma(00000359)= 0.125905998096571E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 360 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000360)= 0.000000000000000E+00 beta (00000360)= 0.134398738897684E+02 gamma(00000360)= 0.134398738897684E+02 z1= 1 -0.325914113861530E-03 0.000000000000000E+00 z1= 2 0.113994935768691E-06 0.000000000000000E+00 z1= 3 -0.778384832973537E-07 0.000000000000000E+00 Lanczos iteration: 361 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000361)= 0.000000000000000E+00 beta (00000361)= 0.122152663137850E+02 gamma(00000361)= 0.122152663137850E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 362 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000362)= 0.000000000000000E+00 beta (00000362)= 0.132245810279148E+02 gamma(00000362)= 0.132245810279148E+02 z1= 1 0.297984573943018E-03 0.000000000000000E+00 z1= 2 -0.102312841903512E-06 0.000000000000000E+00 z1= 3 0.809513003371823E-07 0.000000000000000E+00 Lanczos iteration: 363 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000363)= 0.000000000000000E+00 beta (00000363)= 0.124895005097541E+02 gamma(00000363)= 0.124895005097541E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 364 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.6E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000364)= 0.000000000000000E+00 beta (00000364)= 0.132936635340401E+02 gamma(00000364)= 0.132936635340401E+02 z1= 1 -0.287071103997015E-03 0.000000000000000E+00 z1= 2 0.968790675641776E-07 0.000000000000000E+00 z1= 3 -0.810280821655820E-07 0.000000000000000E+00 Lanczos iteration: 365 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000365)= 0.000000000000000E+00 beta (00000365)= 0.126231283131886E+02 gamma(00000365)= 0.126231283131886E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 366 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.9E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000366)= 0.000000000000000E+00 beta (00000366)= 0.129059169999242E+02 gamma(00000366)= 0.129059169999242E+02 z1= 1 0.277793439187245E-03 0.000000000000000E+00 z1= 2 -0.922775691596447E-07 0.000000000000000E+00 z1= 3 0.881804525561941E-07 0.000000000000000E+00 Lanczos iteration: 367 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000367)= 0.000000000000000E+00 beta (00000367)= 0.124422324713029E+02 gamma(00000367)= 0.124422324713029E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 368 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.3E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000368)= 0.000000000000000E+00 beta (00000368)= 0.136426977465353E+02 gamma(00000368)= 0.136426977465353E+02 z1= 1 -0.253993239210454E-03 0.000000000000000E+00 z1= 2 0.846554670348373E-07 0.000000000000000E+00 z1= 3 -0.838249871211580E-07 0.000000000000000E+00 Lanczos iteration: 369 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000369)= 0.000000000000000E+00 beta (00000369)= 0.128093246704025E+02 gamma(00000369)= 0.128093246704025E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 370 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.3E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000370)= 0.000000000000000E+00 beta (00000370)= 0.134556233530173E+02 gamma(00000370)= 0.134556233530173E+02 z1= 1 0.236222489552521E-03 0.000000000000000E+00 z1= 2 -0.787395993242027E-07 0.000000000000000E+00 z1= 3 0.889944879757781E-07 0.000000000000000E+00 Lanczos iteration: 371 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000371)= 0.000000000000000E+00 beta (00000371)= 0.123746943808598E+02 gamma(00000371)= 0.123746943808598E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 372 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.8E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000372)= 0.000000000000000E+00 beta (00000372)= 0.131576348417854E+02 gamma(00000372)= 0.131576348417854E+02 z1= 1 -0.218155195347852E-03 0.000000000000000E+00 z1= 2 0.781096384750921E-07 0.000000000000000E+00 z1= 3 -0.866204209611868E-07 0.000000000000000E+00 Lanczos iteration: 373 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000373)= 0.000000000000000E+00 beta (00000373)= 0.127721724019582E+02 gamma(00000373)= 0.127721724019582E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 374 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.4E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000374)= 0.000000000000000E+00 beta (00000374)= 0.136706025952986E+02 gamma(00000374)= 0.136706025952986E+02 z1= 1 0.197679473483873E-03 0.000000000000000E+00 z1= 2 -0.731960076230664E-07 0.000000000000000E+00 z1= 3 0.925269702197243E-07 0.000000000000000E+00 Lanczos iteration: 375 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000375)= 0.000000000000000E+00 beta (00000375)= 0.128191500968653E+02 gamma(00000375)= 0.128191500968653E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 376 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000376)= 0.000000000000000E+00 beta (00000376)= 0.134510001286238E+02 gamma(00000376)= 0.134510001286238E+02 z1= 1 -0.182687926276008E-03 0.000000000000000E+00 z1= 2 0.754140622137578E-07 0.000000000000000E+00 z1= 3 -0.888585795238593E-07 0.000000000000000E+00 Lanczos iteration: 377 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000377)= 0.000000000000000E+00 beta (00000377)= 0.124611964383601E+02 gamma(00000377)= 0.124611964383601E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 378 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.7E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000378)= 0.000000000000000E+00 beta (00000378)= 0.131575820513249E+02 gamma(00000378)= 0.131575820513249E+02 z1= 1 0.166878962496685E-03 0.000000000000000E+00 z1= 2 -0.710771887119446E-07 0.000000000000000E+00 z1= 3 0.968032361874094E-07 0.000000000000000E+00 Lanczos iteration: 379 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000379)= 0.000000000000000E+00 beta (00000379)= 0.124285557182351E+02 gamma(00000379)= 0.124285557182351E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 380 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.7E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000380)= 0.000000000000000E+00 beta (00000380)= 0.131318722677486E+02 gamma(00000380)= 0.131318722677486E+02 z1= 1 -0.149715340483275E-03 0.000000000000000E+00 z1= 2 0.769845281993128E-07 0.000000000000000E+00 z1= 3 -0.896523529180957E-07 0.000000000000000E+00 Lanczos iteration: 381 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000381)= 0.000000000000000E+00 beta (00000381)= 0.126462549262837E+02 gamma(00000381)= 0.126462549262837E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 382 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000382)= 0.000000000000000E+00 beta (00000382)= 0.134598423066936E+02 gamma(00000382)= 0.134598423066936E+02 z1= 1 0.135906336031725E-03 0.000000000000000E+00 z1= 2 -0.729567008811091E-07 0.000000000000000E+00 z1= 3 0.102059428274130E-06 0.000000000000000E+00 Lanczos iteration: 383 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000383)= 0.000000000000000E+00 beta (00000383)= 0.125009578344255E+02 gamma(00000383)= 0.125009578344255E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 384 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000384)= 0.000000000000000E+00 beta (00000384)= 0.131940833584263E+02 gamma(00000384)= 0.131940833584263E+02 z1= 1 -0.120240870853394E-03 0.000000000000000E+00 z1= 2 0.865395495767279E-07 0.000000000000000E+00 z1= 3 -0.892071710610056E-07 0.000000000000000E+00 Lanczos iteration: 385 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000385)= 0.000000000000000E+00 beta (00000385)= 0.125637193344302E+02 gamma(00000385)= 0.125637193344302E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 386 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000386)= 0.000000000000000E+00 beta (00000386)= 0.130278898332948E+02 gamma(00000386)= 0.130278898332948E+02 z1= 1 0.114372006469044E-03 0.000000000000000E+00 z1= 2 -0.802716946012375E-07 0.000000000000000E+00 z1= 3 0.115970516329921E-06 0.000000000000000E+00 Lanczos iteration: 387 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000387)= 0.000000000000000E+00 beta (00000387)= 0.125569233470814E+02 gamma(00000387)= 0.125569233470814E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 388 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.8E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000388)= 0.000000000000000E+00 beta (00000388)= 0.136333835253924E+02 gamma(00000388)= 0.136333835253924E+02 z1= 1 -0.981057374957912E-04 0.000000000000000E+00 z1= 2 0.994386030782682E-07 0.000000000000000E+00 z1= 3 -0.850810064445366E-07 0.000000000000000E+00 Lanczos iteration: 389 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000389)= 0.000000000000000E+00 beta (00000389)= 0.127309332570019E+02 gamma(00000389)= 0.127309332570019E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 390 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.0E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000390)= 0.000000000000000E+00 beta (00000390)= 0.131557793996250E+02 gamma(00000390)= 0.131557793996250E+02 z1= 1 0.979734565696470E-04 0.000000000000000E+00 z1= 2 -0.807487684031417E-07 0.000000000000000E+00 z1= 3 0.130474606294221E-06 0.000000000000000E+00 Lanczos iteration: 391 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000391)= 0.000000000000000E+00 beta (00000391)= 0.127908643935113E+02 gamma(00000391)= 0.127908643935113E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 392 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000392)= 0.000000000000000E+00 beta (00000392)= 0.134330428990746E+02 gamma(00000392)= 0.134330428990746E+02 z1= 1 -0.861142848519736E-04 0.000000000000000E+00 z1= 2 0.112055922425140E-06 0.000000000000000E+00 z1= 3 -0.818940082267976E-07 0.000000000000000E+00 Lanczos iteration: 393 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000393)= 0.000000000000000E+00 beta (00000393)= 0.126880967361407E+02 gamma(00000393)= 0.126880967361407E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 394 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000394)= 0.000000000000000E+00 beta (00000394)= 0.136691863553634E+02 gamma(00000394)= 0.136691863553634E+02 z1= 1 0.851919323018582E-04 0.000000000000000E+00 z1= 2 -0.736144903077697E-07 0.000000000000000E+00 z1= 3 0.144451648380253E-06 0.000000000000000E+00 Lanczos iteration: 395 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000395)= 0.000000000000000E+00 beta (00000395)= 0.125368234018517E+02 gamma(00000395)= 0.125368234018517E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 396 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000396)= 0.000000000000000E+00 beta (00000396)= 0.133089422705960E+02 gamma(00000396)= 0.133089422705960E+02 z1= 1 -0.704634761580451E-04 0.000000000000000E+00 z1= 2 0.115312126255582E-06 0.000000000000000E+00 z1= 3 -0.724908692039490E-07 0.000000000000000E+00 Lanczos iteration: 397 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000397)= 0.000000000000000E+00 beta (00000397)= 0.128653220523551E+02 gamma(00000397)= 0.128653220523551E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 398 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000398)= 0.000000000000000E+00 beta (00000398)= 0.137275360936525E+02 gamma(00000398)= 0.137275360936525E+02 z1= 1 0.695935403183991E-04 0.000000000000000E+00 z1= 2 -0.640466179561636E-07 0.000000000000000E+00 z1= 3 0.159038013723472E-06 0.000000000000000E+00 Lanczos iteration: 399 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000399)= 0.000000000000000E+00 beta (00000399)= 0.123832518559686E+02 gamma(00000399)= 0.123832518559686E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 400 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000400)= 0.000000000000000E+00 beta (00000400)= 0.131534722040456E+02 gamma(00000400)= 0.131534722040456E+02 z1= 1 -0.508726050960241E-04 0.000000000000000E+00 z1= 2 0.117560933429045E-06 0.000000000000000E+00 z1= 3 -0.676863079343906E-07 0.000000000000000E+00 Lanczos iteration: 401 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000401)= 0.000000000000000E+00 beta (00000401)= 0.125259497602957E+02 gamma(00000401)= 0.125259497602957E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 402 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.4E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000402)= 0.000000000000000E+00 beta (00000402)= 0.134807332877153E+02 gamma(00000402)= 0.134807332877153E+02 z1= 1 0.466702900461143E-04 0.000000000000000E+00 z1= 2 -0.478840169963052E-07 0.000000000000000E+00 z1= 3 0.188280534921823E-06 0.000000000000000E+00 Lanczos iteration: 403 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000403)= 0.000000000000000E+00 beta (00000403)= 0.125314237972756E+02 gamma(00000403)= 0.125314237972756E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 404 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.8E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000404)= 0.000000000000000E+00 beta (00000404)= 0.131432855514945E+02 gamma(00000404)= 0.131432855514945E+02 z1= 1 -0.194639844385593E-04 0.000000000000000E+00 z1= 2 0.132936229113242E-06 0.000000000000000E+00 z1= 3 -0.489490898077181E-07 0.000000000000000E+00 Lanczos iteration: 405 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000405)= 0.000000000000000E+00 beta (00000405)= 0.124558737722127E+02 gamma(00000405)= 0.124558737722127E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 406 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.0E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000406)= 0.000000000000000E+00 beta (00000406)= 0.137332126727367E+02 gamma(00000406)= 0.137332126727367E+02 z1= 1 0.150586195996234E-04 0.000000000000000E+00 z1= 2 -0.201339161497519E-07 0.000000000000000E+00 z1= 3 0.241744457471580E-06 0.000000000000000E+00 Lanczos iteration: 407 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000407)= 0.000000000000000E+00 beta (00000407)= 0.125475163334740E+02 gamma(00000407)= 0.125475163334740E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 408 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.9E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000408)= 0.000000000000000E+00 beta (00000408)= 0.131202415320294E+02 gamma(00000408)= 0.131202415320294E+02 z1= 1 0.254155069762483E-04 0.000000000000000E+00 z1= 2 0.166019722727152E-06 0.000000000000000E+00 z1= 3 0.241524762386106E-08 0.000000000000000E+00 Lanczos iteration: 409 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000409)= 0.000000000000000E+00 beta (00000409)= 0.128865688625914E+02 gamma(00000409)= 0.128865688625914E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 410 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.7E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000410)= 0.000000000000000E+00 beta (00000410)= 0.136014667380513E+02 gamma(00000410)= 0.136014667380513E+02 z1= 1 -0.245368729755498E-04 0.000000000000000E+00 z1= 2 0.138772119099781E-07 0.000000000000000E+00 z1= 3 0.316935491789165E-06 0.000000000000000E+00 Lanczos iteration: 411 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000411)= 0.000000000000000E+00 beta (00000411)= 0.126842072113185E+02 gamma(00000411)= 0.126842072113185E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 412 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.3E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000412)= 0.000000000000000E+00 beta (00000412)= 0.135098693516019E+02 gamma(00000412)= 0.135098693516019E+02 z1= 1 0.764729711122784E-04 0.000000000000000E+00 z1= 2 0.201481549057594E-06 0.000000000000000E+00 z1= 3 0.558396713701932E-07 0.000000000000000E+00 Lanczos iteration: 413 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000413)= 0.000000000000000E+00 beta (00000413)= 0.127187355536143E+02 gamma(00000413)= 0.127187355536143E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 414 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000414)= 0.000000000000000E+00 beta (00000414)= 0.138189157047045E+02 gamma(00000414)= 0.138189157047045E+02 z1= 1 -0.692285895122630E-04 0.000000000000000E+00 z1= 2 0.403727353631700E-07 0.000000000000000E+00 z1= 3 0.363924690496343E-06 0.000000000000000E+00 Lanczos iteration: 415 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000415)= 0.000000000000000E+00 beta (00000415)= 0.127185366267729E+02 gamma(00000415)= 0.127185366267729E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 416 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000416)= 0.000000000000000E+00 beta (00000416)= 0.134186830917451E+02 gamma(00000416)= 0.134186830917451E+02 z1= 1 0.129331690557483E-03 0.000000000000000E+00 z1= 2 0.210533947104033E-06 0.000000000000000E+00 z1= 3 0.665429501082223E-07 0.000000000000000E+00 Lanczos iteration: 417 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000417)= 0.000000000000000E+00 beta (00000417)= 0.125871959259488E+02 gamma(00000417)= 0.125871959259488E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 418 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000418)= 0.000000000000000E+00 beta (00000418)= 0.135726146528742E+02 gamma(00000418)= 0.135726146528742E+02 z1= 1 -0.123385604628157E-03 0.000000000000000E+00 z1= 2 0.420609725017979E-07 0.000000000000000E+00 z1= 3 0.377653139792982E-06 0.000000000000000E+00 Lanczos iteration: 419 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000419)= 0.000000000000000E+00 beta (00000419)= 0.130793946359141E+02 gamma(00000419)= 0.130793946359141E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 420 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000420)= 0.000000000000000E+00 beta (00000420)= 0.137323635497330E+02 gamma(00000420)= 0.137323635497330E+02 z1= 1 0.183729713839471E-03 0.000000000000000E+00 z1= 2 0.203485778341866E-06 0.000000000000000E+00 z1= 3 0.391449064038969E-07 0.000000000000000E+00 Lanczos iteration: 421 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000421)= 0.000000000000000E+00 beta (00000421)= 0.125019805908539E+02 gamma(00000421)= 0.125019805908539E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 422 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000422)= 0.000000000000000E+00 beta (00000422)= 0.132621750030981E+02 gamma(00000422)= 0.132621750030981E+02 z1= 1 -0.186874898491968E-03 0.000000000000000E+00 z1= 2 0.981824398171849E-08 0.000000000000000E+00 z1= 3 0.342736734704782E-06 0.000000000000000E+00 Lanczos iteration: 423 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000423)= 0.000000000000000E+00 beta (00000423)= 0.127446606877851E+02 gamma(00000423)= 0.127446606877851E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 424 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000424)= 0.000000000000000E+00 beta (00000424)= 0.136559612174758E+02 gamma(00000424)= 0.136559612174758E+02 z1= 1 0.236491211175492E-03 0.000000000000000E+00 z1= 2 0.173322612949389E-06 0.000000000000000E+00 z1= 3 -0.294483045087729E-07 0.000000000000000E+00 Lanczos iteration: 425 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000425)= 0.000000000000000E+00 beta (00000425)= 0.128916842796733E+02 gamma(00000425)= 0.128916842796733E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 426 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000426)= 0.000000000000000E+00 beta (00000426)= 0.132317845674396E+02 gamma(00000426)= 0.132317845674396E+02 z1= 1 -0.254449068248314E-03 0.000000000000000E+00 z1= 2 -0.249776463123741E-07 0.000000000000000E+00 z1= 3 0.306787342302189E-06 0.000000000000000E+00 Lanczos iteration: 427 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000427)= 0.000000000000000E+00 beta (00000427)= 0.123636442817676E+02 gamma(00000427)= 0.123636442817676E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 428 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.1E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000428)= 0.000000000000000E+00 beta (00000428)= 0.134855397365445E+02 gamma(00000428)= 0.134855397365445E+02 z1= 1 0.289564747303052E-03 0.000000000000000E+00 z1= 2 0.140850806039372E-06 0.000000000000000E+00 z1= 3 -0.104778603468819E-06 0.000000000000000E+00 Lanczos iteration: 429 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000429)= 0.000000000000000E+00 beta (00000429)= 0.125050326989114E+02 gamma(00000429)= 0.125050326989114E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 430 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000430)= 0.000000000000000E+00 beta (00000430)= 0.134599886696494E+02 gamma(00000430)= 0.134599886696494E+02 z1= 1 -0.304249941812419E-03 0.000000000000000E+00 z1= 2 -0.433410293383674E-07 0.000000000000000E+00 z1= 3 0.281043665753826E-06 0.000000000000000E+00 Lanczos iteration: 431 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000431)= 0.000000000000000E+00 beta (00000431)= 0.124027711319840E+02 gamma(00000431)= 0.124027711319840E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 432 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.3E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000432)= 0.000000000000000E+00 beta (00000432)= 0.134520615139985E+02 gamma(00000432)= 0.134520615139985E+02 z1= 1 0.333850233230425E-03 0.000000000000000E+00 z1= 2 0.126152428940596E-06 0.000000000000000E+00 z1= 3 -0.141989387246336E-06 0.000000000000000E+00 Lanczos iteration: 433 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000433)= 0.000000000000000E+00 beta (00000433)= 0.123228718448963E+02 gamma(00000433)= 0.123228718448963E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 434 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.4E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000434)= 0.000000000000000E+00 beta (00000434)= 0.135156940934066E+02 gamma(00000434)= 0.135156940934066E+02 z1= 1 -0.348688589134401E-03 0.000000000000000E+00 z1= 2 -0.477828239814002E-07 0.000000000000000E+00 z1= 3 0.278712834400705E-06 0.000000000000000E+00 Lanczos iteration: 435 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000435)= 0.000000000000000E+00 beta (00000435)= 0.126064328441002E+02 gamma(00000435)= 0.126064328441002E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 436 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.4E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000436)= 0.000000000000000E+00 beta (00000436)= 0.134740782748940E+02 gamma(00000436)= 0.134740782748940E+02 z1= 1 0.376698669641809E-03 0.000000000000000E+00 z1= 2 0.125132722006253E-06 0.000000000000000E+00 z1= 3 -0.154413125916437E-06 0.000000000000000E+00 Lanczos iteration: 437 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000437)= 0.000000000000000E+00 beta (00000437)= 0.122765251164382E+02 gamma(00000437)= 0.122765251164382E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 438 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000438)= 0.000000000000000E+00 beta (00000438)= 0.131435952681465E+02 gamma(00000438)= 0.131435952681465E+02 z1= 1 -0.404036275895400E-03 0.000000000000000E+00 z1= 2 -0.451824108569851E-07 0.000000000000000E+00 z1= 3 0.305789425728161E-06 0.000000000000000E+00 Lanczos iteration: 439 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000439)= 0.000000000000000E+00 beta (00000439)= 0.126683453833655E+02 gamma(00000439)= 0.126683453833655E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 440 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000440)= 0.000000000000000E+00 beta (00000440)= 0.133314828408816E+02 gamma(00000440)= 0.133314828408816E+02 z1= 1 0.430399837418979E-03 0.000000000000000E+00 z1= 2 0.146278833192993E-06 0.000000000000000E+00 z1= 3 -0.148737656434470E-06 0.000000000000000E+00 Lanczos iteration: 441 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000441)= 0.000000000000000E+00 beta (00000441)= 0.127267131526705E+02 gamma(00000441)= 0.127267131526705E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 442 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000442)= 0.000000000000000E+00 beta (00000442)= 0.134987133496302E+02 gamma(00000442)= 0.134987133496302E+02 z1= 1 -0.457754602849386E-03 0.000000000000000E+00 z1= 2 -0.285138861549905E-07 0.000000000000000E+00 z1= 3 0.369176344801997E-06 0.000000000000000E+00 Lanczos iteration: 443 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000443)= 0.000000000000000E+00 beta (00000443)= 0.125404912063770E+02 gamma(00000443)= 0.125404912063770E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 444 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000444)= 0.000000000000000E+00 beta (00000444)= 0.135454525711802E+02 gamma(00000444)= 0.135454525711802E+02 z1= 1 0.463314345685608E-03 0.000000000000000E+00 z1= 2 0.176032647887167E-06 0.000000000000000E+00 z1= 3 -0.124997923934894E-06 0.000000000000000E+00 Lanczos iteration: 445 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000445)= 0.000000000000000E+00 beta (00000445)= 0.124298484122397E+02 gamma(00000445)= 0.124298484122397E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 446 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000446)= 0.000000000000000E+00 beta (00000446)= 0.136290652600949E+02 gamma(00000446)= 0.136290652600949E+02 z1= 1 -0.477714235091586E-03 0.000000000000000E+00 z1= 2 -0.158261863770354E-08 0.000000000000000E+00 z1= 3 0.434336088744728E-06 0.000000000000000E+00 Lanczos iteration: 447 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000447)= 0.000000000000000E+00 beta (00000447)= 0.127534238169207E+02 gamma(00000447)= 0.127534238169207E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 448 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.7E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000448)= 0.000000000000000E+00 beta (00000448)= 0.133015631882711E+02 gamma(00000448)= 0.133015631882711E+02 z1= 1 0.493423205044448E-03 0.000000000000000E+00 z1= 2 0.214675767520184E-06 0.000000000000000E+00 z1= 3 -0.938008920282072E-07 0.000000000000000E+00 Lanczos iteration: 449 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000449)= 0.000000000000000E+00 beta (00000449)= 0.128008769069279E+02 gamma(00000449)= 0.128008769069279E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 450 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000450)= 0.000000000000000E+00 beta (00000450)= 0.134702763891308E+02 gamma(00000450)= 0.134702763891308E+02 z1= 1 -0.527101836538896E-03 0.000000000000000E+00 z1= 2 0.175458106189746E-07 0.000000000000000E+00 z1= 3 0.520118816310687E-06 0.000000000000000E+00 Lanczos iteration: 451 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000451)= 0.000000000000000E+00 beta (00000451)= 0.125868982835883E+02 gamma(00000451)= 0.125868982835883E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 452 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000452)= 0.000000000000000E+00 beta (00000452)= 0.133782636713241E+02 gamma(00000452)= 0.133782636713241E+02 z1= 1 0.525043875631489E-03 0.000000000000000E+00 z1= 2 0.257953139019135E-06 0.000000000000000E+00 z1= 3 -0.604698155956844E-07 0.000000000000000E+00 Lanczos iteration: 453 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000453)= 0.000000000000000E+00 beta (00000453)= 0.128128585389037E+02 gamma(00000453)= 0.128128585389037E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 454 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000454)= 0.000000000000000E+00 beta (00000454)= 0.136401518595931E+02 gamma(00000454)= 0.136401518595931E+02 z1= 1 -0.553716761898260E-03 0.000000000000000E+00 z1= 2 0.463000239046656E-07 0.000000000000000E+00 z1= 3 0.604931287286948E-06 0.000000000000000E+00 Lanczos iteration: 455 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000455)= 0.000000000000000E+00 beta (00000455)= 0.122784434655341E+02 gamma(00000455)= 0.122784434655341E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 456 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000456)= 0.000000000000000E+00 beta (00000456)= 0.136624546109269E+02 gamma(00000456)= 0.136624546109269E+02 z1= 1 0.522007371105943E-03 0.000000000000000E+00 z1= 2 0.298760101579906E-06 0.000000000000000E+00 z1= 3 -0.416633367638763E-08 0.000000000000000E+00 Lanczos iteration: 457 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000457)= 0.000000000000000E+00 beta (00000457)= 0.129417843785648E+02 gamma(00000457)= 0.129417843785648E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 458 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000458)= 0.000000000000000E+00 beta (00000458)= 0.134977278272771E+02 gamma(00000458)= 0.134977278272771E+02 z1= 1 -0.568380859967111E-03 0.000000000000000E+00 z1= 2 0.741071707064181E-07 0.000000000000000E+00 z1= 3 0.679786558362182E-06 0.000000000000000E+00 Lanczos iteration: 459 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000459)= 0.000000000000000E+00 beta (00000459)= 0.129522833037316E+02 gamma(00000459)= 0.129522833037316E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 460 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000460)= 0.000000000000000E+00 beta (00000460)= 0.137233804249124E+02 gamma(00000460)= 0.137233804249124E+02 z1= 1 0.558254345885215E-03 0.000000000000000E+00 z1= 2 0.304701524457031E-06 0.000000000000000E+00 z1= 3 -0.453094012185166E-07 0.000000000000000E+00 Lanczos iteration: 461 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000461)= 0.000000000000000E+00 beta (00000461)= 0.125953907851331E+02 gamma(00000461)= 0.125953907851331E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 462 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000462)= 0.000000000000000E+00 beta (00000462)= 0.133950655907189E+02 gamma(00000462)= 0.133950655907189E+02 z1= 1 -0.592804601028233E-03 0.000000000000000E+00 z1= 2 0.341951553826242E-07 0.000000000000000E+00 z1= 3 0.657041128455721E-06 0.000000000000000E+00 Lanczos iteration: 463 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000463)= 0.000000000000000E+00 beta (00000463)= 0.127214920935843E+02 gamma(00000463)= 0.127214920935843E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 464 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000464)= 0.000000000000000E+00 beta (00000464)= 0.133143963377626E+02 gamma(00000464)= 0.133143963377626E+02 z1= 1 0.595980392855654E-03 0.000000000000000E+00 z1= 2 0.275898289651098E-06 0.000000000000000E+00 z1= 3 -0.149379203792270E-06 0.000000000000000E+00 Lanczos iteration: 465 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000465)= 0.000000000000000E+00 beta (00000465)= 0.127253556390002E+02 gamma(00000465)= 0.127253556390002E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 466 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000466)= 0.000000000000000E+00 beta (00000466)= 0.134192940328907E+02 gamma(00000466)= 0.134192940328907E+02 z1= 1 -0.631529624638940E-03 0.000000000000000E+00 z1= 2 -0.644325225986064E-09 0.000000000000000E+00 z1= 3 0.649235710188049E-06 0.000000000000000E+00 Lanczos iteration: 467 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000467)= 0.000000000000000E+00 beta (00000467)= 0.127652888580068E+02 gamma(00000467)= 0.127652888580068E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 468 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000468)= 0.000000000000000E+00 beta (00000468)= 0.135751850772763E+02 gamma(00000468)= 0.135751850772763E+02 z1= 1 0.627065008707095E-03 0.000000000000000E+00 z1= 2 0.254869445665516E-06 0.000000000000000E+00 z1= 3 -0.227767962436912E-06 0.000000000000000E+00 Lanczos iteration: 469 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000469)= 0.000000000000000E+00 beta (00000469)= 0.125430247847226E+02 gamma(00000469)= 0.125430247847226E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 470 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000470)= 0.000000000000000E+00 beta (00000470)= 0.136357416250769E+02 gamma(00000470)= 0.136357416250769E+02 z1= 1 -0.643861338216076E-03 0.000000000000000E+00 z1= 2 -0.310112832453344E-07 0.000000000000000E+00 z1= 3 0.621307672651563E-06 0.000000000000000E+00 Lanczos iteration: 471 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000471)= 0.000000000000000E+00 beta (00000471)= 0.129043398225596E+02 gamma(00000471)= 0.129043398225596E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 472 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.7E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000472)= 0.000000000000000E+00 beta (00000472)= 0.131632102527488E+02 gamma(00000472)= 0.131632102527488E+02 z1= 1 0.673677931460649E-03 0.000000000000000E+00 z1= 2 0.225054834591260E-06 0.000000000000000E+00 z1= 3 -0.331707626160800E-06 0.000000000000000E+00 Lanczos iteration: 473 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000473)= 0.000000000000000E+00 beta (00000473)= 0.127842412972798E+02 gamma(00000473)= 0.127842412972798E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 474 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000474)= 0.000000000000000E+00 beta (00000474)= 0.135780594492382E+02 gamma(00000474)= 0.135780594492382E+02 z1= 1 -0.699063759599518E-03 0.000000000000000E+00 z1= 2 -0.752699334544832E-07 0.000000000000000E+00 z1= 3 0.607759558693627E-06 0.000000000000000E+00 Lanczos iteration: 475 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000475)= 0.000000000000000E+00 beta (00000475)= 0.126234499587747E+02 gamma(00000475)= 0.126234499587747E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 476 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000476)= 0.000000000000000E+00 beta (00000476)= 0.130129357996410E+02 gamma(00000476)= 0.130129357996410E+02 z1= 1 0.728624460767067E-03 0.000000000000000E+00 z1= 2 0.194894075173507E-06 0.000000000000000E+00 z1= 3 -0.444786535752704E-06 0.000000000000000E+00 Lanczos iteration: 477 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000477)= 0.000000000000000E+00 beta (00000477)= 0.122936037339227E+02 gamma(00000477)= 0.122936037339227E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 478 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000478)= 0.000000000000000E+00 beta (00000478)= 0.135108594037016E+02 gamma(00000478)= 0.135108594037016E+02 z1= 1 -0.728588949687158E-03 0.000000000000000E+00 z1= 2 -0.104122672309713E-06 0.000000000000000E+00 z1= 3 0.599614623742958E-06 0.000000000000000E+00 Lanczos iteration: 479 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000479)= 0.000000000000000E+00 beta (00000479)= 0.128238988593478E+02 gamma(00000479)= 0.128238988593478E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 480 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000480)= 0.000000000000000E+00 beta (00000480)= 0.133210784948262E+02 gamma(00000480)= 0.133210784948262E+02 z1= 1 0.755515131988942E-03 0.000000000000000E+00 z1= 2 0.182740343269809E-06 0.000000000000000E+00 z1= 3 -0.504054997980041E-06 0.000000000000000E+00 Lanczos iteration: 481 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000481)= 0.000000000000000E+00 beta (00000481)= 0.130057064186728E+02 gamma(00000481)= 0.130057064186728E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 482 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000482)= 0.000000000000000E+00 beta (00000482)= 0.133050101971201E+02 gamma(00000482)= 0.133050101971201E+02 z1= 1 -0.803578117615743E-03 0.000000000000000E+00 z1= 2 -0.131922981170228E-06 0.000000000000000E+00 z1= 3 0.640687408008981E-06 0.000000000000000E+00 Lanczos iteration: 483 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000483)= 0.000000000000000E+00 beta (00000483)= 0.122315336055388E+02 gamma(00000483)= 0.122315336055388E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 484 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.4E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000484)= 0.000000000000000E+00 beta (00000484)= 0.131720789279690E+02 gamma(00000484)= 0.131720789279690E+02 z1= 1 0.806593771526976E-03 0.000000000000000E+00 z1= 2 0.174516400066292E-06 0.000000000000000E+00 z1= 3 -0.574911578270047E-06 0.000000000000000E+00 Lanczos iteration: 485 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000485)= 0.000000000000000E+00 beta (00000485)= 0.129964803964612E+02 gamma(00000485)= 0.129964803964612E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 486 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.9E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000486)= 0.000000000000000E+00 beta (00000486)= 0.131456240827641E+02 gamma(00000486)= 0.131456240827641E+02 z1= 1 -0.863182891376997E-03 0.000000000000000E+00 z1= 2 -0.150304398039737E-06 0.000000000000000E+00 z1= 3 0.677945327731385E-06 0.000000000000000E+00 Lanczos iteration: 487 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000487)= 0.000000000000000E+00 beta (00000487)= 0.125242328351095E+02 gamma(00000487)= 0.125242328351095E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 488 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.7E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000488)= 0.000000000000000E+00 beta (00000488)= 0.137264632361498E+02 gamma(00000488)= 0.137264632361498E+02 z1= 1 0.846559829392454E-03 0.000000000000000E+00 z1= 2 0.172870722345460E-06 0.000000000000000E+00 z1= 3 -0.626785954448649E-06 0.000000000000000E+00 Lanczos iteration: 489 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000489)= 0.000000000000000E+00 beta (00000489)= 0.130941228316591E+02 gamma(00000489)= 0.130941228316591E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 490 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000490)= 0.000000000000000E+00 beta (00000490)= 0.132923782670205E+02 gamma(00000490)= 0.132923782670205E+02 z1= 1 -0.897002750549207E-03 0.000000000000000E+00 z1= 2 -0.163260018551901E-06 0.000000000000000E+00 z1= 3 0.703050843736349E-06 0.000000000000000E+00 Lanczos iteration: 491 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000491)= 0.000000000000000E+00 beta (00000491)= 0.122824811543290E+02 gamma(00000491)= 0.122824811543290E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 492 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.7E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000492)= 0.000000000000000E+00 beta (00000492)= 0.133117392886442E+02 gamma(00000492)= 0.133117392886442E+02 z1= 1 0.891465897635536E-03 0.000000000000000E+00 z1= 2 0.171532979566062E-06 0.000000000000000E+00 z1= 3 -0.689081777310407E-06 0.000000000000000E+00 Lanczos iteration: 493 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000493)= 0.000000000000000E+00 beta (00000493)= 0.126686280385794E+02 gamma(00000493)= 0.126686280385794E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 494 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000494)= 0.000000000000000E+00 beta (00000494)= 0.134404956607413E+02 gamma(00000494)= 0.134404956607413E+02 z1= 1 -0.901564288345424E-03 0.000000000000000E+00 z1= 2 -0.168053356933498E-06 0.000000000000000E+00 z1= 3 0.711576810618177E-06 0.000000000000000E+00 Lanczos iteration: 495 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000495)= 0.000000000000000E+00 beta (00000495)= 0.120543908410044E+02 gamma(00000495)= 0.120543908410044E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 496 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000496)= 0.000000000000000E+00 beta (00000496)= 0.133060290456126E+02 gamma(00000496)= 0.133060290456126E+02 z1= 1 0.887380632704458E-03 0.000000000000000E+00 z1= 2 0.158180830912846E-06 0.000000000000000E+00 z1= 3 -0.714965399823742E-06 0.000000000000000E+00 Lanczos iteration: 497 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000497)= 0.000000000000000E+00 beta (00000497)= 0.123129611487807E+02 gamma(00000497)= 0.123129611487807E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 498 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000498)= 0.000000000000000E+00 beta (00000498)= 0.130342393353655E+02 gamma(00000498)= 0.130342393353655E+02 z1= 1 -0.904435083427566E-03 0.000000000000000E+00 z1= 2 -0.172575483806982E-06 0.000000000000000E+00 z1= 3 0.720258261580043E-06 0.000000000000000E+00 Lanczos iteration: 499 Pol:1 lr_apply_liouvillian: not applying interaction alpha(00000499)= 0.000000000000000E+00 beta (00000499)= 0.127073393768124E+02 gamma(00000499)= 0.127073393768124E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 500 Pol:1 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000500)= 0.000000000000000E+00 beta (00000500)= 0.128237181823960E+02 gamma(00000500)= 0.128237181823960E+02 z1= 1 0.976307037102615E-03 0.000000000000000E+00 z1= 2 0.160227874761512E-06 0.000000000000000E+00 z1= 3 -0.823136720177337E-06 0.000000000000000E+00 Reading d0psi Starting Lanczos loop 2 Lanczos iteration: 1 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000001)= 0.000000000000000E+00 beta (00000001)= 0.198589802022020E+01 gamma(00000001)= 0.198589802022020E+01 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 2 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.0E-13, # of iterations = 17 lr_apply_liouvillian: applying interaction: normal alpha(00000002)= 0.000000000000000E+00 beta (00000002)= 0.266005240590936E+01 gamma(00000002)= 0.266005240590936E+01 z1= 1 -0.607268679685830E-06 0.000000000000000E+00 z1= 2 0.746563494692242E+00 0.000000000000000E+00 z1= 3 -0.963967109238704E-08 0.000000000000000E+00 Lanczos iteration: 3 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000003)= 0.000000000000000E+00 beta (00000003)= 0.941281351066085E+01 gamma(00000003)= 0.941281351066085E+01 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 4 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.7E-13, # of iterations = 18 lr_apply_liouvillian: applying interaction: normal alpha(00000004)= 0.000000000000000E+00 beta (00000004)= 0.143357352503855E+02 gamma(00000004)= 0.143357352503855E+02 z1= 1 0.427960738659527E-06 0.000000000000000E+00 z1= 2 -0.490192015035738E+00 0.000000000000000E+00 z1= 3 0.777322900469800E-08 0.000000000000000E+00 Lanczos iteration: 5 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000005)= 0.000000000000000E+00 beta (00000005)= 0.121882185670267E+02 gamma(00000005)= 0.121882185670267E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 6 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.9E-13, # of iterations = 19 lr_apply_liouvillian: applying interaction: normal alpha(00000006)= 0.000000000000000E+00 beta (00000006)= 0.138954278333717E+02 gamma(00000006)= 0.138954278333717E+02 z1= 1 -0.411470553296489E-06 0.000000000000000E+00 z1= 2 0.429966269382298E+00 0.000000000000000E+00 z1= 3 -0.808922694843853E-08 0.000000000000000E+00 Lanczos iteration: 7 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000007)= 0.000000000000000E+00 beta (00000007)= 0.124798897793248E+02 gamma(00000007)= 0.124798897793248E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 8 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 19 lr_apply_liouvillian: applying interaction: normal alpha(00000008)= 0.000000000000000E+00 beta (00000008)= 0.135517560292448E+02 gamma(00000008)= 0.135517560292448E+02 z1= 1 0.418346378207660E-06 0.000000000000000E+00 z1= 2 -0.395959398764825E+00 0.000000000000000E+00 z1= 3 0.881847072860091E-08 0.000000000000000E+00 Lanczos iteration: 9 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000009)= 0.000000000000000E+00 beta (00000009)= 0.126276613900503E+02 gamma(00000009)= 0.126276613900503E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 10 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.3E-13, # of iterations = 18 lr_apply_liouvillian: applying interaction: normal alpha(00000010)= 0.000000000000000E+00 beta (00000010)= 0.134087277754858E+02 gamma(00000010)= 0.134087277754858E+02 z1= 1 -0.431785882219066E-06 0.000000000000000E+00 z1= 2 0.372893554592300E+00 0.000000000000000E+00 z1= 3 -0.100332487546016E-07 0.000000000000000E+00 Lanczos iteration: 11 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000011)= 0.000000000000000E+00 beta (00000011)= 0.126837832139528E+02 gamma(00000011)= 0.126837832139528E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 12 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.4E-13, # of iterations = 18 lr_apply_liouvillian: applying interaction: normal alpha(00000012)= 0.000000000000000E+00 beta (00000012)= 0.133788011540097E+02 gamma(00000012)= 0.133788011540097E+02 z1= 1 0.443567789710358E-06 0.000000000000000E+00 z1= 2 -0.353516128965973E+00 0.000000000000000E+00 z1= 3 0.104770603429928E-07 0.000000000000000E+00 Lanczos iteration: 13 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000013)= 0.000000000000000E+00 beta (00000013)= 0.126912058353664E+02 gamma(00000013)= 0.126912058353664E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 14 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.7E-13, # of iterations = 18 lr_apply_liouvillian: applying interaction: normal alpha(00000014)= 0.000000000000000E+00 beta (00000014)= 0.134095362952056E+02 gamma(00000014)= 0.134095362952056E+02 z1= 1 -0.451398400547198E-06 0.000000000000000E+00 z1= 2 0.334568452378799E+00 0.000000000000000E+00 z1= 3 -0.958584654123414E-08 0.000000000000000E+00 Lanczos iteration: 15 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000015)= 0.000000000000000E+00 beta (00000015)= 0.127243800367691E+02 gamma(00000015)= 0.127243800367691E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 16 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.9E-13, # of iterations = 18 lr_apply_liouvillian: applying interaction: normal alpha(00000016)= 0.000000000000000E+00 beta (00000016)= 0.134837701208214E+02 gamma(00000016)= 0.134837701208214E+02 z1= 1 0.454643127279289E-06 0.000000000000000E+00 z1= 2 -0.315713828232767E+00 0.000000000000000E+00 z1= 3 0.822323314108274E-08 0.000000000000000E+00 Lanczos iteration: 17 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000017)= 0.000000000000000E+00 beta (00000017)= 0.127724884825654E+02 gamma(00000017)= 0.127724884825654E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 18 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.0E-13, # of iterations = 18 lr_apply_liouvillian: applying interaction: normal alpha(00000018)= 0.000000000000000E+00 beta (00000018)= 0.134686870580551E+02 gamma(00000018)= 0.134686870580551E+02 z1= 1 -0.456315627729922E-06 0.000000000000000E+00 z1= 2 0.299381340040431E+00 0.000000000000000E+00 z1= 3 -0.682772103091644E-08 0.000000000000000E+00 Lanczos iteration: 19 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000019)= 0.000000000000000E+00 beta (00000019)= 0.126919484992113E+02 gamma(00000019)= 0.126919484992113E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 20 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.1E-13, # of iterations = 18 lr_apply_liouvillian: applying interaction: normal alpha(00000020)= 0.000000000000000E+00 beta (00000020)= 0.133778264251946E+02 gamma(00000020)= 0.133778264251946E+02 z1= 1 0.456729514236587E-06 0.000000000000000E+00 z1= 2 -0.284018370368617E+00 0.000000000000000E+00 z1= 3 0.460974260868031E-08 0.000000000000000E+00 Lanczos iteration: 21 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000021)= 0.000000000000000E+00 beta (00000021)= 0.127277684705722E+02 gamma(00000021)= 0.127277684705722E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 22 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.4E-13, # of iterations = 18 lr_apply_liouvillian: applying interaction: normal alpha(00000022)= 0.000000000000000E+00 beta (00000022)= 0.134706316298381E+02 gamma(00000022)= 0.134706316298381E+02 z1= 1 -0.454864183443981E-06 0.000000000000000E+00 z1= 2 0.268340876936982E+00 0.000000000000000E+00 z1= 3 -0.157094870228622E-08 0.000000000000000E+00 Lanczos iteration: 23 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000023)= 0.000000000000000E+00 beta (00000023)= 0.127895856424420E+02 gamma(00000023)= 0.127895856424420E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 24 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.6E-13, # of iterations = 17 lr_apply_liouvillian: applying interaction: normal alpha(00000024)= 0.000000000000000E+00 beta (00000024)= 0.134414478846668E+02 gamma(00000024)= 0.134414478846668E+02 z1= 1 0.456724316850662E-06 0.000000000000000E+00 z1= 2 -0.255310140749761E+00 0.000000000000000E+00 z1= 3 -0.194992374807565E-08 0.000000000000000E+00 Lanczos iteration: 25 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000025)= 0.000000000000000E+00 beta (00000025)= 0.128720201073474E+02 gamma(00000025)= 0.128720201073474E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 26 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.5E-13, # of iterations = 17 lr_apply_liouvillian: applying interaction: normal alpha(00000026)= 0.000000000000000E+00 beta (00000026)= 0.136147873355579E+02 gamma(00000026)= 0.136147873355579E+02 z1= 1 -0.456157386375874E-06 0.000000000000000E+00 z1= 2 0.241361266261862E+00 0.000000000000000E+00 z1= 3 0.557145498226302E-08 0.000000000000000E+00 Lanczos iteration: 27 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000027)= 0.000000000000000E+00 beta (00000027)= 0.129098258795439E+02 gamma(00000027)= 0.129098258795439E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 28 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.5E-13, # of iterations = 17 lr_apply_liouvillian: applying interaction: normal alpha(00000028)= 0.000000000000000E+00 beta (00000028)= 0.134503407293927E+02 gamma(00000028)= 0.134503407293927E+02 z1= 1 0.463206528321380E-06 0.000000000000000E+00 z1= 2 -0.231637002732084E+00 0.000000000000000E+00 z1= 3 -0.794960250231902E-08 0.000000000000000E+00 Lanczos iteration: 29 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000029)= 0.000000000000000E+00 beta (00000029)= 0.128064915148153E+02 gamma(00000029)= 0.128064915148153E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 30 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.5E-13, # of iterations = 17 lr_apply_liouvillian: applying interaction: normal alpha(00000030)= 0.000000000000000E+00 beta (00000030)= 0.134315415738108E+02 gamma(00000030)= 0.134315415738108E+02 z1= 1 -0.467730427622555E-06 0.000000000000000E+00 z1= 2 0.220827517593796E+00 0.000000000000000E+00 z1= 3 0.893068771408781E-08 0.000000000000000E+00 Lanczos iteration: 31 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000031)= 0.000000000000000E+00 beta (00000031)= 0.127433346490026E+02 gamma(00000031)= 0.127433346490026E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 32 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.6E-13, # of iterations = 17 lr_apply_liouvillian: applying interaction: normal alpha(00000032)= 0.000000000000000E+00 beta (00000032)= 0.133606741422484E+02 gamma(00000032)= 0.133606741422484E+02 z1= 1 0.473413357475819E-06 0.000000000000000E+00 z1= 2 -0.210588321996368E+00 0.000000000000000E+00 z1= 3 -0.999497087525447E-08 0.000000000000000E+00 Lanczos iteration: 33 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000033)= 0.000000000000000E+00 beta (00000033)= 0.126539858357790E+02 gamma(00000033)= 0.126539858357790E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 34 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.8E-13, # of iterations = 17 lr_apply_liouvillian: applying interaction: normal alpha(00000034)= 0.000000000000000E+00 beta (00000034)= 0.132882596891544E+02 gamma(00000034)= 0.132882596891544E+02 z1= 1 -0.478253157078570E-06 0.000000000000000E+00 z1= 2 0.200495036468702E+00 0.000000000000000E+00 z1= 3 0.115633448519517E-07 0.000000000000000E+00 Lanczos iteration: 35 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000035)= 0.000000000000000E+00 beta (00000035)= 0.128109594980341E+02 gamma(00000035)= 0.128109594980341E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 36 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 17 lr_apply_liouvillian: applying interaction: normal alpha(00000036)= 0.000000000000000E+00 beta (00000036)= 0.133259665029610E+02 gamma(00000036)= 0.133259665029610E+02 z1= 1 0.484887178272067E-06 0.000000000000000E+00 z1= 2 -0.192700826210537E+00 0.000000000000000E+00 z1= 3 -0.135563984465098E-07 0.000000000000000E+00 Lanczos iteration: 37 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000037)= 0.000000000000000E+00 beta (00000037)= 0.125858713111730E+02 gamma(00000037)= 0.125858713111730E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 38 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.2E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000038)= 0.000000000000000E+00 beta (00000038)= 0.135292392577402E+02 gamma(00000038)= 0.135292392577402E+02 z1= 1 -0.474968653906525E-06 0.000000000000000E+00 z1= 2 0.179214392011839E+00 0.000000000000000E+00 z1= 3 0.156036353759700E-07 0.000000000000000E+00 Lanczos iteration: 39 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000039)= 0.000000000000000E+00 beta (00000039)= 0.129363583402128E+02 gamma(00000039)= 0.129363583402128E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 40 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.0E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000040)= 0.000000000000000E+00 beta (00000040)= 0.132944732796770E+02 gamma(00000040)= 0.132944732796770E+02 z1= 1 0.485697385045267E-06 0.000000000000000E+00 z1= 2 -0.174332978794308E+00 0.000000000000000E+00 z1= 3 -0.186296673179188E-07 0.000000000000000E+00 Lanczos iteration: 41 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000041)= 0.000000000000000E+00 beta (00000041)= 0.126617379930714E+02 gamma(00000041)= 0.126617379930714E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 42 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.0E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000042)= 0.000000000000000E+00 beta (00000042)= 0.132829351290373E+02 gamma(00000042)= 0.132829351290373E+02 z1= 1 -0.485591658105911E-06 0.000000000000000E+00 z1= 2 0.166123285074305E+00 0.000000000000000E+00 z1= 3 0.209641877624983E-07 0.000000000000000E+00 Lanczos iteration: 43 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000043)= 0.000000000000000E+00 beta (00000043)= 0.127919688568373E+02 gamma(00000043)= 0.127919688568373E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 44 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.3E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000044)= 0.000000000000000E+00 beta (00000044)= 0.134450776276760E+02 gamma(00000044)= 0.134450776276760E+02 z1= 1 0.484846909570499E-06 0.000000000000000E+00 z1= 2 -0.157996428153150E+00 0.000000000000000E+00 z1= 3 -0.230587859557409E-07 0.000000000000000E+00 Lanczos iteration: 45 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000045)= 0.000000000000000E+00 beta (00000045)= 0.127158789254995E+02 gamma(00000045)= 0.127158789254995E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 46 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.6E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000046)= 0.000000000000000E+00 beta (00000046)= 0.133682119896688E+02 gamma(00000046)= 0.133682119896688E+02 z1= 1 -0.486437447324087E-06 0.000000000000000E+00 z1= 2 0.150227648486203E+00 0.000000000000000E+00 z1= 3 0.249926729585341E-07 0.000000000000000E+00 Lanczos iteration: 47 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000047)= 0.000000000000000E+00 beta (00000047)= 0.126050505375985E+02 gamma(00000047)= 0.126050505375985E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 48 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.0E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000048)= 0.000000000000000E+00 beta (00000048)= 0.132920680562831E+02 gamma(00000048)= 0.132920680562831E+02 z1= 1 0.488253147868864E-06 0.000000000000000E+00 z1= 2 -0.142402696875013E+00 0.000000000000000E+00 z1= 3 -0.265663869336401E-07 0.000000000000000E+00 Lanczos iteration: 49 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000049)= 0.000000000000000E+00 beta (00000049)= 0.126245782300759E+02 gamma(00000049)= 0.126245782300759E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 50 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.5E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000050)= 0.000000000000000E+00 beta (00000050)= 0.131105415353492E+02 gamma(00000050)= 0.131105415353492E+02 z1= 1 -0.497376961035648E-06 0.000000000000000E+00 z1= 2 0.137063460884060E+00 0.000000000000000E+00 z1= 3 0.285256863590336E-07 0.000000000000000E+00 Lanczos iteration: 51 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000051)= 0.000000000000000E+00 beta (00000051)= 0.126514651086877E+02 gamma(00000051)= 0.126514651086877E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 52 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000052)= 0.000000000000000E+00 beta (00000052)= 0.131546961753608E+02 gamma(00000052)= 0.131546961753608E+02 z1= 1 0.504819401387149E-06 0.000000000000000E+00 z1= 2 -0.131761610731100E+00 0.000000000000000E+00 z1= 3 -0.303536454131226E-07 0.000000000000000E+00 Lanczos iteration: 53 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000053)= 0.000000000000000E+00 beta (00000053)= 0.127236106083763E+02 gamma(00000053)= 0.127236106083763E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 54 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000054)= 0.000000000000000E+00 beta (00000054)= 0.132489679736447E+02 gamma(00000054)= 0.132489679736447E+02 z1= 1 -0.510586926473142E-06 0.000000000000000E+00 z1= 2 0.126481389175710E+00 0.000000000000000E+00 z1= 3 0.318332379527567E-07 0.000000000000000E+00 Lanczos iteration: 55 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000055)= 0.000000000000000E+00 beta (00000055)= 0.126569520129611E+02 gamma(00000055)= 0.126569520129611E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 56 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000056)= 0.000000000000000E+00 beta (00000056)= 0.134572454279337E+02 gamma(00000056)= 0.134572454279337E+02 z1= 1 0.505641217488431E-06 0.000000000000000E+00 z1= 2 -0.118907623771702E+00 0.000000000000000E+00 z1= 3 -0.315110092359572E-07 0.000000000000000E+00 Lanczos iteration: 57 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000057)= 0.000000000000000E+00 beta (00000057)= 0.127068693620917E+02 gamma(00000057)= 0.127068693620917E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 58 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000058)= 0.000000000000000E+00 beta (00000058)= 0.134315233934486E+02 gamma(00000058)= 0.134315233934486E+02 z1= 1 -0.503691078126804E-06 0.000000000000000E+00 z1= 2 0.112441845619226E+00 0.000000000000000E+00 z1= 3 0.315661813597712E-07 0.000000000000000E+00 Lanczos iteration: 59 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000059)= 0.000000000000000E+00 beta (00000059)= 0.127673282929296E+02 gamma(00000059)= 0.127673282929296E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 60 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000060)= 0.000000000000000E+00 beta (00000060)= 0.132464505767158E+02 gamma(00000060)= 0.132464505767158E+02 z1= 1 0.510561005718883E-06 0.000000000000000E+00 z1= 2 -0.108327045740289E+00 0.000000000000000E+00 z1= 3 -0.328411099087891E-07 0.000000000000000E+00 Lanczos iteration: 61 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000061)= 0.000000000000000E+00 beta (00000061)= 0.125205662204799E+02 gamma(00000061)= 0.125205662204799E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 62 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000062)= 0.000000000000000E+00 beta (00000062)= 0.133161523819588E+02 gamma(00000062)= 0.133161523819588E+02 z1= 1 -0.504598864099932E-06 0.000000000000000E+00 z1= 2 0.101809320647229E+00 0.000000000000000E+00 z1= 3 0.335869392740704E-07 0.000000000000000E+00 Lanczos iteration: 63 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000063)= 0.000000000000000E+00 beta (00000063)= 0.125430150826998E+02 gamma(00000063)= 0.125430150826998E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 64 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.7E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000064)= 0.000000000000000E+00 beta (00000064)= 0.131850898611758E+02 gamma(00000064)= 0.131850898611758E+02 z1= 1 0.504423261364455E-06 0.000000000000000E+00 z1= 2 -0.968092218417980E-01 0.000000000000000E+00 z1= 3 -0.347200955919807E-07 0.000000000000000E+00 Lanczos iteration: 65 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000065)= 0.000000000000000E+00 beta (00000065)= 0.126814827913472E+02 gamma(00000065)= 0.126814827913472E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 66 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000066)= 0.000000000000000E+00 beta (00000066)= 0.131033412747936E+02 gamma(00000066)= 0.131033412747936E+02 z1= 1 -0.511696266549538E-06 0.000000000000000E+00 z1= 2 0.936523619668985E-01 0.000000000000000E+00 z1= 3 0.361960559042834E-07 0.000000000000000E+00 Lanczos iteration: 67 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000067)= 0.000000000000000E+00 beta (00000067)= 0.128533754325921E+02 gamma(00000067)= 0.128533754325921E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 68 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000068)= 0.000000000000000E+00 beta (00000068)= 0.132983812588322E+02 gamma(00000068)= 0.132983812588322E+02 z1= 1 0.516965001497866E-06 0.000000000000000E+00 z1= 2 -0.904846616028820E-01 0.000000000000000E+00 z1= 3 -0.375073086339439E-07 0.000000000000000E+00 Lanczos iteration: 69 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000069)= 0.000000000000000E+00 beta (00000069)= 0.127670656769979E+02 gamma(00000069)= 0.127670656769979E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 70 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000070)= 0.000000000000000E+00 beta (00000070)= 0.130919762990591E+02 gamma(00000070)= 0.130919762990591E+02 z1= 1 -0.526919417395341E-06 0.000000000000000E+00 z1= 2 0.882066862354367E-01 0.000000000000000E+00 z1= 3 0.386371720728640E-07 0.000000000000000E+00 Lanczos iteration: 71 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000071)= 0.000000000000000E+00 beta (00000071)= 0.127418950480276E+02 gamma(00000071)= 0.127418950480276E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 72 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000072)= 0.000000000000000E+00 beta (00000072)= 0.133775460884131E+02 gamma(00000072)= 0.133775460884131E+02 z1= 1 0.523578613487521E-06 0.000000000000000E+00 z1= 2 -0.839901475523482E-01 0.000000000000000E+00 z1= 3 -0.389419474730937E-07 0.000000000000000E+00 Lanczos iteration: 73 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000073)= 0.000000000000000E+00 beta (00000073)= 0.126213865253188E+02 gamma(00000073)= 0.126213865253188E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 74 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000074)= 0.000000000000000E+00 beta (00000074)= 0.133181119749113E+02 gamma(00000074)= 0.133181119749113E+02 z1= 1 -0.518241644428125E-06 0.000000000000000E+00 z1= 2 0.795707202689936E-01 0.000000000000000E+00 z1= 3 0.389552747732946E-07 0.000000000000000E+00 Lanczos iteration: 75 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000075)= 0.000000000000000E+00 beta (00000075)= 0.129522737460825E+02 gamma(00000075)= 0.129522737460825E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 76 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000076)= 0.000000000000000E+00 beta (00000076)= 0.136072444081992E+02 gamma(00000076)= 0.136072444081992E+02 z1= 1 0.513891736685090E-06 0.000000000000000E+00 z1= 2 -0.757224298210465E-01 0.000000000000000E+00 z1= 3 -0.394680720367142E-07 0.000000000000000E+00 Lanczos iteration: 77 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000077)= 0.000000000000000E+00 beta (00000077)= 0.130542573688065E+02 gamma(00000077)= 0.130542573688065E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 78 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000078)= 0.000000000000000E+00 beta (00000078)= 0.134946658383189E+02 gamma(00000078)= 0.134946658383189E+02 z1= 1 -0.517447235887439E-06 0.000000000000000E+00 z1= 2 0.732313015066602E-01 0.000000000000000E+00 z1= 3 0.412192167858864E-07 0.000000000000000E+00 Lanczos iteration: 79 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000079)= 0.000000000000000E+00 beta (00000079)= 0.128475295162381E+02 gamma(00000079)= 0.128475295162381E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 80 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000080)= 0.000000000000000E+00 beta (00000080)= 0.135769041696386E+02 gamma(00000080)= 0.135769041696386E+02 z1= 1 0.509670002984616E-06 0.000000000000000E+00 z1= 2 -0.692847664196976E-01 0.000000000000000E+00 z1= 3 -0.417616072743120E-07 0.000000000000000E+00 Lanczos iteration: 81 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000081)= 0.000000000000000E+00 beta (00000081)= 0.127359363632178E+02 gamma(00000081)= 0.127359363632178E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 82 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000082)= 0.000000000000000E+00 beta (00000082)= 0.133647102095672E+02 gamma(00000082)= 0.133647102095672E+02 z1= 1 -0.506814970204980E-06 0.000000000000000E+00 z1= 2 0.660109109284501E-01 0.000000000000000E+00 z1= 3 0.423806419598029E-07 0.000000000000000E+00 Lanczos iteration: 83 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000083)= 0.000000000000000E+00 beta (00000083)= 0.126879899698879E+02 gamma(00000083)= 0.126879899698879E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 84 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000084)= 0.000000000000000E+00 beta (00000084)= 0.135878677274114E+02 gamma(00000084)= 0.135878677274114E+02 z1= 1 0.494106876573752E-06 0.000000000000000E+00 z1= 2 -0.616317814260816E-01 0.000000000000000E+00 z1= 3 -0.421947933514901E-07 0.000000000000000E+00 Lanczos iteration: 85 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000085)= 0.000000000000000E+00 beta (00000085)= 0.129027219232699E+02 gamma(00000085)= 0.129027219232699E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 86 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000086)= 0.000000000000000E+00 beta (00000086)= 0.134800197464407E+02 gamma(00000086)= 0.134800197464407E+02 z1= 1 -0.493658738835029E-06 0.000000000000000E+00 z1= 2 0.589840485550080E-01 0.000000000000000E+00 z1= 3 0.432532062226714E-07 0.000000000000000E+00 Lanczos iteration: 87 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000087)= 0.000000000000000E+00 beta (00000087)= 0.125464489528648E+02 gamma(00000087)= 0.125464489528648E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 88 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000088)= 0.000000000000000E+00 beta (00000088)= 0.131711339906842E+02 gamma(00000088)= 0.131711339906842E+02 z1= 1 0.492952585310485E-06 0.000000000000000E+00 z1= 2 -0.561828892962225E-01 0.000000000000000E+00 z1= 3 -0.450372835639353E-07 0.000000000000000E+00 Lanczos iteration: 89 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000089)= 0.000000000000000E+00 beta (00000089)= 0.127109052522311E+02 gamma(00000089)= 0.127109052522311E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 90 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000090)= 0.000000000000000E+00 beta (00000090)= 0.135664026911339E+02 gamma(00000090)= 0.135664026911339E+02 z1= 1 -0.484667482512219E-06 0.000000000000000E+00 z1= 2 0.526362021713098E-01 0.000000000000000E+00 z1= 3 0.455747976880203E-07 0.000000000000000E+00 Lanczos iteration: 91 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000091)= 0.000000000000000E+00 beta (00000091)= 0.126763943561199E+02 gamma(00000091)= 0.126763943561199E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 92 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000092)= 0.000000000000000E+00 beta (00000092)= 0.131206267819404E+02 gamma(00000092)= 0.131206267819404E+02 z1= 1 0.493889587701093E-06 0.000000000000000E+00 z1= 2 -0.508535346238963E-01 0.000000000000000E+00 z1= 3 -0.476472051635750E-07 0.000000000000000E+00 Lanczos iteration: 93 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000093)= 0.000000000000000E+00 beta (00000093)= 0.127417699114273E+02 gamma(00000093)= 0.127417699114273E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 94 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000094)= 0.000000000000000E+00 beta (00000094)= 0.131244096176239E+02 gamma(00000094)= 0.131244096176239E+02 z1= 1 -0.505026517045107E-06 0.000000000000000E+00 z1= 2 0.493703075455434E-01 0.000000000000000E+00 z1= 3 0.507972059793187E-07 0.000000000000000E+00 Lanczos iteration: 95 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000095)= 0.000000000000000E+00 beta (00000095)= 0.126167543812140E+02 gamma(00000095)= 0.126167543812140E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 96 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000096)= 0.000000000000000E+00 beta (00000096)= 0.130501923693937E+02 gamma(00000096)= 0.130501923693937E+02 z1= 1 0.513357005651333E-06 0.000000000000000E+00 z1= 2 -0.477319550815956E-01 0.000000000000000E+00 z1= 3 -0.536586257367071E-07 0.000000000000000E+00 Lanczos iteration: 97 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000097)= 0.000000000000000E+00 beta (00000097)= 0.129305753065117E+02 gamma(00000097)= 0.129305753065117E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 98 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000098)= 0.000000000000000E+00 beta (00000098)= 0.130694914366899E+02 gamma(00000098)= 0.130694914366899E+02 z1= 1 -0.532347000169187E-06 0.000000000000000E+00 z1= 2 0.472258596197309E-01 0.000000000000000E+00 z1= 3 0.563962399410464E-07 0.000000000000000E+00 Lanczos iteration: 99 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000099)= 0.000000000000000E+00 beta (00000099)= 0.128250170421889E+02 gamma(00000099)= 0.128250170421889E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 100 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000100)= 0.000000000000000E+00 beta (00000100)= 0.132936073027035E+02 gamma(00000100)= 0.132936073027035E+02 z1= 1 0.536921588842332E-06 0.000000000000000E+00 z1= 2 -0.455632212873932E-01 0.000000000000000E+00 z1= 3 -0.567988010140644E-07 0.000000000000000E+00 Lanczos iteration: 101 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000101)= 0.000000000000000E+00 beta (00000101)= 0.127825663012384E+02 gamma(00000101)= 0.127825663012384E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 102 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000102)= 0.000000000000000E+00 beta (00000102)= 0.129699886506958E+02 gamma(00000102)= 0.129699886506958E+02 z1= 1 -0.553193719857355E-06 0.000000000000000E+00 z1= 2 0.449073133409795E-01 0.000000000000000E+00 z1= 3 0.580066039520231E-07 0.000000000000000E+00 Lanczos iteration: 103 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000103)= 0.000000000000000E+00 beta (00000103)= 0.126639014577565E+02 gamma(00000103)= 0.126639014577565E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 104 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000104)= 0.000000000000000E+00 beta (00000104)= 0.135222537170826E+02 gamma(00000104)= 0.135222537170826E+02 z1= 1 0.539684102316383E-06 0.000000000000000E+00 z1= 2 -0.420591342381776E-01 0.000000000000000E+00 z1= 3 -0.564879998072448E-07 0.000000000000000E+00 Lanczos iteration: 105 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000105)= 0.000000000000000E+00 beta (00000105)= 0.129400864438861E+02 gamma(00000105)= 0.129400864438861E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 106 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000106)= 0.000000000000000E+00 beta (00000106)= 0.132777653509665E+02 gamma(00000106)= 0.132777653509665E+02 z1= 1 -0.547063129663870E-06 0.000000000000000E+00 z1= 2 0.409929915816382E-01 0.000000000000000E+00 z1= 3 0.570381362432169E-07 0.000000000000000E+00 Lanczos iteration: 107 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000107)= 0.000000000000000E+00 beta (00000107)= 0.127551167265639E+02 gamma(00000107)= 0.127551167265639E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 108 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000108)= 0.000000000000000E+00 beta (00000108)= 0.134610344346570E+02 gamma(00000108)= 0.134610344346570E+02 z1= 1 0.539003538004446E-06 0.000000000000000E+00 z1= 2 -0.388464487312141E-01 0.000000000000000E+00 z1= 3 -0.555276715992307E-07 0.000000000000000E+00 Lanczos iteration: 109 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000109)= 0.000000000000000E+00 beta (00000109)= 0.130004317288076E+02 gamma(00000109)= 0.130004317288076E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 110 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000110)= 0.000000000000000E+00 beta (00000110)= 0.134801526769435E+02 gamma(00000110)= 0.134801526769435E+02 z1= 1 -0.540253670921337E-06 0.000000000000000E+00 z1= 2 0.374694791480430E-01 0.000000000000000E+00 z1= 3 0.555976479754867E-07 0.000000000000000E+00 Lanczos iteration: 111 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000111)= 0.000000000000000E+00 beta (00000111)= 0.126592419557951E+02 gamma(00000111)= 0.126592419557951E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 112 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000112)= 0.000000000000000E+00 beta (00000112)= 0.132260718103707E+02 gamma(00000112)= 0.132260718103707E+02 z1= 1 0.538049063142018E-06 0.000000000000000E+00 z1= 2 -0.358686007676923E-01 0.000000000000000E+00 z1= 3 -0.565771201962648E-07 0.000000000000000E+00 Lanczos iteration: 113 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000113)= 0.000000000000000E+00 beta (00000113)= 0.125787397500275E+02 gamma(00000113)= 0.125787397500275E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 114 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000114)= 0.000000000000000E+00 beta (00000114)= 0.130416125583933E+02 gamma(00000114)= 0.130416125583933E+02 z1= 1 -0.539708742642621E-06 0.000000000000000E+00 z1= 2 0.346035180397230E-01 0.000000000000000E+00 z1= 3 0.580000741774722E-07 0.000000000000000E+00 Lanczos iteration: 115 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000115)= 0.000000000000000E+00 beta (00000115)= 0.124651390876538E+02 gamma(00000115)= 0.124651390876538E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 116 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000116)= 0.000000000000000E+00 beta (00000116)= 0.133127285987094E+02 gamma(00000116)= 0.133127285987094E+02 z1= 1 0.525178761378014E-06 0.000000000000000E+00 z1= 2 -0.324061303707064E-01 0.000000000000000E+00 z1= 3 -0.577795164834020E-07 0.000000000000000E+00 Lanczos iteration: 117 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000117)= 0.000000000000000E+00 beta (00000117)= 0.129165493684932E+02 gamma(00000117)= 0.129165493684932E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 118 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000118)= 0.000000000000000E+00 beta (00000118)= 0.133529956442986E+02 gamma(00000118)= 0.133529956442986E+02 z1= 1 -0.526313867193345E-06 0.000000000000000E+00 z1= 2 0.313560096846781E-01 0.000000000000000E+00 z1= 3 0.594355699218806E-07 0.000000000000000E+00 Lanczos iteration: 119 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000119)= 0.000000000000000E+00 beta (00000119)= 0.129231227492306E+02 gamma(00000119)= 0.129231227492306E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 120 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000120)= 0.000000000000000E+00 beta (00000120)= 0.133421827196658E+02 gamma(00000120)= 0.133421827196658E+02 z1= 1 0.526983500925057E-06 0.000000000000000E+00 z1= 2 -0.303761328782707E-01 0.000000000000000E+00 z1= 3 -0.601733179566352E-07 0.000000000000000E+00 Lanczos iteration: 121 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000121)= 0.000000000000000E+00 beta (00000121)= 0.130723306141893E+02 gamma(00000121)= 0.130723306141893E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 122 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000122)= 0.000000000000000E+00 beta (00000122)= 0.138308549774762E+02 gamma(00000122)= 0.138308549774762E+02 z1= 1 -0.513462936947619E-06 0.000000000000000E+00 z1= 2 0.287200602350317E-01 0.000000000000000E+00 z1= 3 0.591486542290704E-07 0.000000000000000E+00 Lanczos iteration: 123 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000123)= 0.000000000000000E+00 beta (00000123)= 0.126092676928179E+02 gamma(00000123)= 0.126092676928179E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 124 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000124)= 0.000000000000000E+00 beta (00000124)= 0.133723388182978E+02 gamma(00000124)= 0.133723388182978E+02 z1= 1 0.500023334517111E-06 0.000000000000000E+00 z1= 2 -0.270863570720631E-01 0.000000000000000E+00 z1= 3 -0.582638745410787E-07 0.000000000000000E+00 Lanczos iteration: 125 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000125)= 0.000000000000000E+00 beta (00000125)= 0.129909457418783E+02 gamma(00000125)= 0.129909457418783E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 126 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000126)= 0.000000000000000E+00 beta (00000126)= 0.136629589212276E+02 gamma(00000126)= 0.136629589212276E+02 z1= 1 -0.491670041847126E-06 0.000000000000000E+00 z1= 2 0.257640324083231E-01 0.000000000000000E+00 z1= 3 0.583662275791246E-07 0.000000000000000E+00 Lanczos iteration: 127 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000127)= 0.000000000000000E+00 beta (00000127)= 0.125949638270356E+02 gamma(00000127)= 0.125949638270356E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 128 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.7E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000128)= 0.000000000000000E+00 beta (00000128)= 0.132210257824964E+02 gamma(00000128)= 0.132210257824964E+02 z1= 1 0.487812645675115E-06 0.000000000000000E+00 z1= 2 -0.245495443704122E-01 0.000000000000000E+00 z1= 3 -0.589639037878336E-07 0.000000000000000E+00 Lanczos iteration: 129 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000129)= 0.000000000000000E+00 beta (00000129)= 0.126762612849512E+02 gamma(00000129)= 0.126762612849512E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 130 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000130)= 0.000000000000000E+00 beta (00000130)= 0.134394375646270E+02 gamma(00000130)= 0.134394375646270E+02 z1= 1 -0.479887858133212E-06 0.000000000000000E+00 z1= 2 0.231648965279068E-01 0.000000000000000E+00 z1= 3 0.588129755658056E-07 0.000000000000000E+00 Lanczos iteration: 131 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000131)= 0.000000000000000E+00 beta (00000131)= 0.129683536143233E+02 gamma(00000131)= 0.129683536143233E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 132 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000132)= 0.000000000000000E+00 beta (00000132)= 0.133084838904077E+02 gamma(00000132)= 0.133084838904077E+02 z1= 1 0.487455788707094E-06 0.000000000000000E+00 z1= 2 -0.225784755867897E-01 0.000000000000000E+00 z1= 3 -0.603710226022315E-07 0.000000000000000E+00 Lanczos iteration: 133 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000133)= 0.000000000000000E+00 beta (00000133)= 0.126237286947359E+02 gamma(00000133)= 0.126237286947359E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 134 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000134)= 0.000000000000000E+00 beta (00000134)= 0.133179044435085E+02 gamma(00000134)= 0.133179044435085E+02 z1= 1 -0.482520926111708E-06 0.000000000000000E+00 z1= 2 0.214107150944795E-01 0.000000000000000E+00 z1= 3 0.605368397990917E-07 0.000000000000000E+00 Lanczos iteration: 135 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000135)= 0.000000000000000E+00 beta (00000135)= 0.126289529349716E+02 gamma(00000135)= 0.126289529349716E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 136 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000136)= 0.000000000000000E+00 beta (00000136)= 0.134393087083246E+02 gamma(00000136)= 0.134393087083246E+02 z1= 1 0.474074012485684E-06 0.000000000000000E+00 z1= 2 -0.201264502072114E-01 0.000000000000000E+00 z1= 3 -0.607401737335255E-07 0.000000000000000E+00 Lanczos iteration: 137 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000137)= 0.000000000000000E+00 beta (00000137)= 0.129299239688248E+02 gamma(00000137)= 0.129299239688248E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 138 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000138)= 0.000000000000000E+00 beta (00000138)= 0.132395557061680E+02 gamma(00000138)= 0.132395557061680E+02 z1= 1 -0.483814460469460E-06 0.000000000000000E+00 z1= 2 0.196649572569214E-01 0.000000000000000E+00 z1= 3 0.634879345631041E-07 0.000000000000000E+00 Lanczos iteration: 139 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000139)= 0.000000000000000E+00 beta (00000139)= 0.128022782665917E+02 gamma(00000139)= 0.128022782665917E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 140 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000140)= 0.000000000000000E+00 beta (00000140)= 0.135041953307632E+02 gamma(00000140)= 0.135041953307632E+02 z1= 1 0.477812840371863E-06 0.000000000000000E+00 z1= 2 -0.186503042277538E-01 0.000000000000000E+00 z1= 3 -0.635014686496617E-07 0.000000000000000E+00 Lanczos iteration: 141 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000141)= 0.000000000000000E+00 beta (00000141)= 0.123992242999924E+02 gamma(00000141)= 0.123992242999924E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 142 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.7E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000142)= 0.000000000000000E+00 beta (00000142)= 0.132323141067291E+02 gamma(00000142)= 0.132323141067291E+02 z1= 1 -0.467433658307703E-06 0.000000000000000E+00 z1= 2 0.174859688785387E-01 0.000000000000000E+00 z1= 3 0.619708053476082E-07 0.000000000000000E+00 Lanczos iteration: 143 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000143)= 0.000000000000000E+00 beta (00000143)= 0.127233603279539E+02 gamma(00000143)= 0.127233603279539E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 144 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000144)= 0.000000000000000E+00 beta (00000144)= 0.133308995982379E+02 gamma(00000144)= 0.133308995982379E+02 z1= 1 0.466562878639713E-06 0.000000000000000E+00 z1= 2 -0.166984262403472E-01 0.000000000000000E+00 z1= 3 -0.607637722595993E-07 0.000000000000000E+00 Lanczos iteration: 145 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000145)= 0.000000000000000E+00 beta (00000145)= 0.125952676364498E+02 gamma(00000145)= 0.125952676364498E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 146 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000146)= 0.000000000000000E+00 beta (00000146)= 0.131254502605908E+02 gamma(00000146)= 0.131254502605908E+02 z1= 1 -0.469820763315289E-06 0.000000000000000E+00 z1= 2 0.160342838594381E-01 0.000000000000000E+00 z1= 3 0.604421855761013E-07 0.000000000000000E+00 Lanczos iteration: 147 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000147)= 0.000000000000000E+00 beta (00000147)= 0.122693123703040E+02 gamma(00000147)= 0.122693123703040E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 148 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.7E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000148)= 0.000000000000000E+00 beta (00000148)= 0.136721767004338E+02 gamma(00000148)= 0.136721767004338E+02 z1= 1 0.442653358347263E-06 0.000000000000000E+00 z1= 2 -0.143988505947359E-01 0.000000000000000E+00 z1= 3 -0.567075064319272E-07 0.000000000000000E+00 Lanczos iteration: 149 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000149)= 0.000000000000000E+00 beta (00000149)= 0.127424769734582E+02 gamma(00000149)= 0.127424769734582E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 150 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000150)= 0.000000000000000E+00 beta (00000150)= 0.128121019760240E+02 gamma(00000150)= 0.128121019760240E+02 z1= 1 -0.462779230936405E-06 0.000000000000000E+00 z1= 2 0.143315632673905E-01 0.000000000000000E+00 z1= 3 0.591460738404766E-07 0.000000000000000E+00 Lanczos iteration: 151 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000151)= 0.000000000000000E+00 beta (00000151)= 0.129240475350248E+02 gamma(00000151)= 0.129240475350248E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 152 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000152)= 0.000000000000000E+00 beta (00000152)= 0.135196729335496E+02 gamma(00000152)= 0.135196729335496E+02 z1= 1 0.463686546716205E-06 0.000000000000000E+00 z1= 2 -0.137100273304451E-01 0.000000000000000E+00 z1= 3 -0.601067127218528E-07 0.000000000000000E+00 Lanczos iteration: 153 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000153)= 0.000000000000000E+00 beta (00000153)= 0.124271514532082E+02 gamma(00000153)= 0.124271514532082E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 154 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000154)= 0.000000000000000E+00 beta (00000154)= 0.132349532988447E+02 gamma(00000154)= 0.132349532988447E+02 z1= 1 -0.458696480619761E-06 0.000000000000000E+00 z1= 2 0.128833468265660E-01 0.000000000000000E+00 z1= 3 0.602010581396157E-07 0.000000000000000E+00 Lanczos iteration: 155 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000155)= 0.000000000000000E+00 beta (00000155)= 0.126019360328143E+02 gamma(00000155)= 0.126019360328143E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 156 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000156)= 0.000000000000000E+00 beta (00000156)= 0.131294104892668E+02 gamma(00000156)= 0.131294104892668E+02 z1= 1 0.463651041112539E-06 0.000000000000000E+00 z1= 2 -0.123769477070792E-01 0.000000000000000E+00 z1= 3 -0.610606969856167E-07 0.000000000000000E+00 Lanczos iteration: 157 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000157)= 0.000000000000000E+00 beta (00000157)= 0.125730245609559E+02 gamma(00000157)= 0.125730245609559E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 158 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000158)= 0.000000000000000E+00 beta (00000158)= 0.130732531168919E+02 gamma(00000158)= 0.130732531168919E+02 z1= 1 -0.468766565448267E-06 0.000000000000000E+00 z1= 2 0.119138514138141E-01 0.000000000000000E+00 z1= 3 0.614706866628074E-07 0.000000000000000E+00 Lanczos iteration: 159 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000159)= 0.000000000000000E+00 beta (00000159)= 0.128978810107739E+02 gamma(00000159)= 0.128978810107739E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 160 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000160)= 0.000000000000000E+00 beta (00000160)= 0.129100121252057E+02 gamma(00000160)= 0.129100121252057E+02 z1= 1 0.490877335503417E-06 0.000000000000000E+00 z1= 2 -0.119150520040345E-01 0.000000000000000E+00 z1= 3 -0.632192895975645E-07 0.000000000000000E+00 Lanczos iteration: 161 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000161)= 0.000000000000000E+00 beta (00000161)= 0.127630306993661E+02 gamma(00000161)= 0.127630306993661E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 162 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000162)= 0.000000000000000E+00 beta (00000162)= 0.131500196260823E+02 gamma(00000162)= 0.131500196260823E+02 z1= 1 -0.496644366888843E-06 0.000000000000000E+00 z1= 2 0.115738344520598E-01 0.000000000000000E+00 z1= 3 0.637071099897184E-07 0.000000000000000E+00 Lanczos iteration: 163 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000163)= 0.000000000000000E+00 beta (00000163)= 0.128823679909345E+02 gamma(00000163)= 0.128823679909345E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 164 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000164)= 0.000000000000000E+00 beta (00000164)= 0.134169524305285E+02 gamma(00000164)= 0.134169524305285E+02 z1= 1 0.496291561340179E-06 0.000000000000000E+00 z1= 2 -0.111255063942806E-01 0.000000000000000E+00 z1= 3 -0.642267756361704E-07 0.000000000000000E+00 Lanczos iteration: 165 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000165)= 0.000000000000000E+00 beta (00000165)= 0.124885803003309E+02 gamma(00000165)= 0.124885803003309E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 166 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000166)= 0.000000000000000E+00 beta (00000166)= 0.134111516482912E+02 gamma(00000166)= 0.134111516482912E+02 z1= 1 -0.481737509300251E-06 0.000000000000000E+00 z1= 2 0.103688477447346E-01 0.000000000000000E+00 z1= 3 0.619481293939912E-07 0.000000000000000E+00 Lanczos iteration: 167 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000167)= 0.000000000000000E+00 beta (00000167)= 0.125627942974054E+02 gamma(00000167)= 0.125627942974054E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 168 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000168)= 0.000000000000000E+00 beta (00000168)= 0.132703919712987E+02 gamma(00000168)= 0.132703919712987E+02 z1= 1 0.476367672188824E-06 0.000000000000000E+00 z1= 2 -0.983027547177144E-02 0.000000000000000E+00 z1= 3 -0.592749173655184E-07 0.000000000000000E+00 Lanczos iteration: 169 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000169)= 0.000000000000000E+00 beta (00000169)= 0.128533729970490E+02 gamma(00000169)= 0.128533729970490E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 170 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000170)= 0.000000000000000E+00 beta (00000170)= 0.137433373324510E+02 gamma(00000170)= 0.137433373324510E+02 z1= 1 -0.465636161026475E-06 0.000000000000000E+00 z1= 2 0.919998058881971E-02 0.000000000000000E+00 z1= 3 0.554531916323320E-07 0.000000000000000E+00 Lanczos iteration: 171 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000171)= 0.000000000000000E+00 beta (00000171)= 0.125742286736687E+02 gamma(00000171)= 0.125742286736687E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 172 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.7E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000172)= 0.000000000000000E+00 beta (00000172)= 0.132348507716833E+02 gamma(00000172)= 0.132348507716833E+02 z1= 1 0.464385186462087E-06 0.000000000000000E+00 z1= 2 -0.875602629758250E-02 0.000000000000000E+00 z1= 3 -0.544712436554087E-07 0.000000000000000E+00 Lanczos iteration: 173 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000173)= 0.000000000000000E+00 beta (00000173)= 0.129770037278938E+02 gamma(00000173)= 0.129770037278938E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 174 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000174)= 0.000000000000000E+00 beta (00000174)= 0.132145107946055E+02 gamma(00000174)= 0.132145107946055E+02 z1= 1 -0.476626917408733E-06 0.000000000000000E+00 z1= 2 0.860272862415400E-02 0.000000000000000E+00 z1= 3 0.555967412101555E-07 0.000000000000000E+00 Lanczos iteration: 175 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000175)= 0.000000000000000E+00 beta (00000175)= 0.129294031135711E+02 gamma(00000175)= 0.129294031135711E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 176 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000176)= 0.000000000000000E+00 beta (00000176)= 0.133047834757194E+02 gamma(00000176)= 0.133047834757194E+02 z1= 1 0.482669458017233E-06 0.000000000000000E+00 z1= 2 -0.837381964439899E-02 0.000000000000000E+00 z1= 3 -0.575255381480774E-07 0.000000000000000E+00 Lanczos iteration: 177 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000177)= 0.000000000000000E+00 beta (00000177)= 0.127261281853905E+02 gamma(00000177)= 0.127261281853905E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 178 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000178)= 0.000000000000000E+00 beta (00000178)= 0.129213709442646E+02 gamma(00000178)= 0.129213709442646E+02 z1= 1 -0.496060617190958E-06 0.000000000000000E+00 z1= 2 0.824722112153557E-02 0.000000000000000E+00 z1= 3 0.592238683832028E-07 0.000000000000000E+00 Lanczos iteration: 179 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000179)= 0.000000000000000E+00 beta (00000179)= 0.130863737325562E+02 gamma(00000179)= 0.130863737325562E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 180 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000180)= 0.000000000000000E+00 beta (00000180)= 0.132719958692122E+02 gamma(00000180)= 0.132719958692122E+02 z1= 1 0.508628694082663E-06 0.000000000000000E+00 z1= 2 -0.814437347374267E-02 0.000000000000000E+00 z1= 3 -0.607458569140684E-07 0.000000000000000E+00 Lanczos iteration: 181 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000181)= 0.000000000000000E+00 beta (00000181)= 0.129054081835268E+02 gamma(00000181)= 0.129054081835268E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 182 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000182)= 0.000000000000000E+00 beta (00000182)= 0.134702969929444E+02 gamma(00000182)= 0.134702969929444E+02 z1= 1 -0.506905341369525E-06 0.000000000000000E+00 z1= 2 0.779702105618376E-02 0.000000000000000E+00 z1= 3 0.603212479189687E-07 0.000000000000000E+00 Lanczos iteration: 183 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000183)= 0.000000000000000E+00 beta (00000183)= 0.127831699911827E+02 gamma(00000183)= 0.127831699911827E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 184 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000184)= 0.000000000000000E+00 beta (00000184)= 0.134151211715953E+02 gamma(00000184)= 0.134151211715953E+02 z1= 1 0.503559278152224E-06 0.000000000000000E+00 z1= 2 -0.744051595783193E-02 0.000000000000000E+00 z1= 3 -0.613263402315153E-07 0.000000000000000E+00 Lanczos iteration: 185 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000185)= 0.000000000000000E+00 beta (00000185)= 0.133785979963327E+02 gamma(00000185)= 0.133785979963327E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 186 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000186)= 0.000000000000000E+00 beta (00000186)= 0.130149021887211E+02 gamma(00000186)= 0.130149021887211E+02 z1= 1 -0.536694995634593E-06 0.000000000000000E+00 z1= 2 0.763925246002612E-02 0.000000000000000E+00 z1= 3 0.663177388382334E-07 0.000000000000000E+00 Lanczos iteration: 187 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000187)= 0.000000000000000E+00 beta (00000187)= 0.128147420365211E+02 gamma(00000187)= 0.128147420365211E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 188 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000188)= 0.000000000000000E+00 beta (00000188)= 0.133730057485716E+02 gamma(00000188)= 0.133730057485716E+02 z1= 1 0.532851667034775E-06 0.000000000000000E+00 z1= 2 -0.732825800109418E-02 0.000000000000000E+00 z1= 3 -0.668925620515674E-07 0.000000000000000E+00 Lanczos iteration: 189 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000189)= 0.000000000000000E+00 beta (00000189)= 0.125372292964758E+02 gamma(00000189)= 0.125372292964758E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 190 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000190)= 0.000000000000000E+00 beta (00000190)= 0.134861795309292E+02 gamma(00000190)= 0.134861795309292E+02 z1= 1 -0.512702862033587E-06 0.000000000000000E+00 z1= 2 0.680216653904967E-02 0.000000000000000E+00 z1= 3 0.647649981441820E-07 0.000000000000000E+00 Lanczos iteration: 191 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000191)= 0.000000000000000E+00 beta (00000191)= 0.129531643651604E+02 gamma(00000191)= 0.129531643651604E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 192 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000192)= 0.000000000000000E+00 beta (00000192)= 0.131339324762857E+02 gamma(00000192)= 0.131339324762857E+02 z1= 1 0.524338132634750E-06 0.000000000000000E+00 z1= 2 -0.671420421104785E-02 0.000000000000000E+00 z1= 3 -0.672839608229251E-07 0.000000000000000E+00 Lanczos iteration: 193 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000193)= 0.000000000000000E+00 beta (00000193)= 0.132315051152719E+02 gamma(00000193)= 0.132315051152719E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 194 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000194)= 0.000000000000000E+00 beta (00000194)= 0.135653501193051E+02 gamma(00000194)= 0.135653501193051E+02 z1= 1 -0.530062580281557E-06 0.000000000000000E+00 z1= 2 0.653807472519764E-02 0.000000000000000E+00 z1= 3 0.680350573438416E-07 0.000000000000000E+00 Lanczos iteration: 195 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000195)= 0.000000000000000E+00 beta (00000195)= 0.127110359668331E+02 gamma(00000195)= 0.127110359668331E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 196 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000196)= 0.000000000000000E+00 beta (00000196)= 0.139186268803086E+02 gamma(00000196)= 0.139186268803086E+02 z1= 1 0.503964335166196E-06 0.000000000000000E+00 z1= 2 -0.597448993567412E-02 0.000000000000000E+00 z1= 3 -0.650962772857249E-07 0.000000000000000E+00 Lanczos iteration: 197 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000197)= 0.000000000000000E+00 beta (00000197)= 0.119716675867113E+02 gamma(00000197)= 0.119716675867113E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 198 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.6E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000198)= 0.000000000000000E+00 beta (00000198)= 0.138616006071883E+02 gamma(00000198)= 0.138616006071883E+02 z1= 1 -0.457028303327278E-06 0.000000000000000E+00 z1= 2 0.515200210815181E-02 0.000000000000000E+00 z1= 3 0.600084501707079E-07 0.000000000000000E+00 Lanczos iteration: 199 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000199)= 0.000000000000000E+00 beta (00000199)= 0.122226528826181E+02 gamma(00000199)= 0.122226528826181E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 200 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.8E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000200)= 0.000000000000000E+00 beta (00000200)= 0.135898916020233E+02 gamma(00000200)= 0.135898916020233E+02 z1= 1 0.434900379214440E-06 0.000000000000000E+00 z1= 2 -0.463448865704649E-02 0.000000000000000E+00 z1= 3 -0.581022396485152E-07 0.000000000000000E+00 Lanczos iteration: 201 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000201)= 0.000000000000000E+00 beta (00000201)= 0.124827077504518E+02 gamma(00000201)= 0.124827077504518E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 202 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.5E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000202)= 0.000000000000000E+00 beta (00000202)= 0.131802638736229E+02 gamma(00000202)= 0.131802638736229E+02 z1= 1 -0.438124385916672E-06 0.000000000000000E+00 z1= 2 0.438308815034386E-02 0.000000000000000E+00 z1= 3 0.579404400051432E-07 0.000000000000000E+00 Lanczos iteration: 203 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000203)= 0.000000000000000E+00 beta (00000203)= 0.128773139105910E+02 gamma(00000203)= 0.128773139105910E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 204 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000204)= 0.000000000000000E+00 beta (00000204)= 0.131000766151336E+02 gamma(00000204)= 0.131000766151336E+02 z1= 1 0.456926220921815E-06 0.000000000000000E+00 z1= 2 -0.430841782107325E-02 0.000000000000000E+00 z1= 3 -0.599183386671082E-07 0.000000000000000E+00 Lanczos iteration: 205 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000205)= 0.000000000000000E+00 beta (00000205)= 0.125951230179718E+02 gamma(00000205)= 0.125951230179718E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 206 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000206)= 0.000000000000000E+00 beta (00000206)= 0.130223108784314E+02 gamma(00000206)= 0.130223108784314E+02 z1= 1 -0.467815604013669E-06 0.000000000000000E+00 z1= 2 0.416471672013017E-02 0.000000000000000E+00 z1= 3 0.604890566065957E-07 0.000000000000000E+00 Lanczos iteration: 207 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000207)= 0.000000000000000E+00 beta (00000207)= 0.127204254750401E+02 gamma(00000207)= 0.127204254750401E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 208 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000208)= 0.000000000000000E+00 beta (00000208)= 0.132745428806500E+02 gamma(00000208)= 0.132745428806500E+02 z1= 1 0.472348620495595E-06 0.000000000000000E+00 z1= 2 -0.399242449468266E-02 0.000000000000000E+00 z1= 3 -0.608311156128239E-07 0.000000000000000E+00 Lanczos iteration: 209 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000209)= 0.000000000000000E+00 beta (00000209)= 0.123805947896146E+02 gamma(00000209)= 0.123805947896146E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 210 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000210)= 0.000000000000000E+00 beta (00000210)= 0.129190506558785E+02 gamma(00000210)= 0.129190506558785E+02 z1= 1 -0.478366258330025E-06 0.000000000000000E+00 z1= 2 0.382714058638203E-02 0.000000000000000E+00 z1= 3 0.616312414605628E-07 0.000000000000000E+00 Lanczos iteration: 211 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000211)= 0.000000000000000E+00 beta (00000211)= 0.126808038473008E+02 gamma(00000211)= 0.126808038473008E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 212 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000212)= 0.000000000000000E+00 beta (00000212)= 0.133848253665253E+02 gamma(00000212)= 0.133848253665253E+02 z1= 1 0.476998626033117E-06 0.000000000000000E+00 z1= 2 -0.362941691138722E-02 0.000000000000000E+00 z1= 3 -0.624202986889734E-07 0.000000000000000E+00 Lanczos iteration: 213 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000213)= 0.000000000000000E+00 beta (00000213)= 0.124456278823954E+02 gamma(00000213)= 0.124456278823954E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 214 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000214)= 0.000000000000000E+00 beta (00000214)= 0.131277595494801E+02 gamma(00000214)= 0.131277595494801E+02 z1= 1 -0.475820099288607E-06 0.000000000000000E+00 z1= 2 0.344426665718559E-02 0.000000000000000E+00 z1= 3 0.631518394709173E-07 0.000000000000000E+00 Lanczos iteration: 215 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000215)= 0.000000000000000E+00 beta (00000215)= 0.126955704909734E+02 gamma(00000215)= 0.126955704909734E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 216 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000216)= 0.000000000000000E+00 beta (00000216)= 0.137084311969116E+02 gamma(00000216)= 0.137084311969116E+02 z1= 1 0.461529245433280E-06 0.000000000000000E+00 z1= 2 -0.319480947957726E-02 0.000000000000000E+00 z1= 3 -0.616760888641314E-07 0.000000000000000E+00 Lanczos iteration: 217 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000217)= 0.000000000000000E+00 beta (00000217)= 0.129679782336891E+02 gamma(00000217)= 0.129679782336891E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 218 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000218)= 0.000000000000000E+00 beta (00000218)= 0.134105086803798E+02 gamma(00000218)= 0.134105086803798E+02 z1= 1 -0.467308316091930E-06 0.000000000000000E+00 z1= 2 0.309361382557377E-02 0.000000000000000E+00 z1= 3 0.623315700703370E-07 0.000000000000000E+00 Lanczos iteration: 219 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000219)= 0.000000000000000E+00 beta (00000219)= 0.125094586903642E+02 gamma(00000219)= 0.125094586903642E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 220 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000220)= 0.000000000000000E+00 beta (00000220)= 0.133534813076793E+02 gamma(00000220)= 0.133534813076793E+02 z1= 1 0.460032557362058E-06 0.000000000000000E+00 z1= 2 -0.290391269727054E-02 0.000000000000000E+00 z1= 3 -0.604654872859468E-07 0.000000000000000E+00 Lanczos iteration: 221 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000221)= 0.000000000000000E+00 beta (00000221)= 0.126732681468283E+02 gamma(00000221)= 0.126732681468283E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 222 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000222)= 0.000000000000000E+00 beta (00000222)= 0.132759024016002E+02 gamma(00000222)= 0.132759024016002E+02 z1= 1 -0.462224910752901E-06 0.000000000000000E+00 z1= 2 0.277685774781365E-02 0.000000000000000E+00 z1= 3 0.594100105031498E-07 0.000000000000000E+00 Lanczos iteration: 223 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000223)= 0.000000000000000E+00 beta (00000223)= 0.124717688181222E+02 gamma(00000223)= 0.124717688181222E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 224 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000224)= 0.000000000000000E+00 beta (00000224)= 0.135248525910440E+02 gamma(00000224)= 0.135248525910440E+02 z1= 1 0.448049871420476E-06 0.000000000000000E+00 z1= 2 -0.256685279154956E-02 0.000000000000000E+00 z1= 3 -0.569623700105194E-07 0.000000000000000E+00 Lanczos iteration: 225 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000225)= 0.000000000000000E+00 beta (00000225)= 0.127989402675979E+02 gamma(00000225)= 0.127989402675979E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 226 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000226)= 0.000000000000000E+00 beta (00000226)= 0.132563069980381E+02 gamma(00000226)= 0.132563069980381E+02 z1= 1 -0.452190582776735E-06 0.000000000000000E+00 z1= 2 0.248353582679553E-02 0.000000000000000E+00 z1= 3 0.573119894437500E-07 0.000000000000000E+00 Lanczos iteration: 227 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000227)= 0.000000000000000E+00 beta (00000227)= 0.121704488878756E+02 gamma(00000227)= 0.121704488878756E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 228 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000228)= 0.000000000000000E+00 beta (00000228)= 0.133980510366631E+02 gamma(00000228)= 0.133980510366631E+02 z1= 1 0.428278271273445E-06 0.000000000000000E+00 z1= 2 -0.226191851571569E-02 0.000000000000000E+00 z1= 3 -0.541072401926204E-07 0.000000000000000E+00 Lanczos iteration: 229 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000229)= 0.000000000000000E+00 beta (00000229)= 0.128288569071332E+02 gamma(00000229)= 0.128288569071332E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 230 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000230)= 0.000000000000000E+00 beta (00000230)= 0.133144475999440E+02 gamma(00000230)= 0.133144475999440E+02 z1= 1 -0.429552015428734E-06 0.000000000000000E+00 z1= 2 0.218440485945451E-02 0.000000000000000E+00 z1= 3 0.535512125056196E-07 0.000000000000000E+00 Lanczos iteration: 231 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000231)= 0.000000000000000E+00 beta (00000231)= 0.126019016136942E+02 gamma(00000231)= 0.126019016136942E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 232 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000232)= 0.000000000000000E+00 beta (00000232)= 0.138146389805579E+02 gamma(00000232)= 0.138146389805579E+02 z1= 1 0.409158718621405E-06 0.000000000000000E+00 z1= 2 -0.199617954855170E-02 0.000000000000000E+00 z1= 3 -0.508206708313419E-07 0.000000000000000E+00 Lanczos iteration: 233 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000233)= 0.000000000000000E+00 beta (00000233)= 0.130317543715194E+02 gamma(00000233)= 0.130317543715194E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 234 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000234)= 0.000000000000000E+00 beta (00000234)= 0.136720471047352E+02 gamma(00000234)= 0.136720471047352E+02 z1= 1 -0.406655711135667E-06 0.000000000000000E+00 z1= 2 0.190626349507046E-02 0.000000000000000E+00 z1= 3 0.505270274786529E-07 0.000000000000000E+00 Lanczos iteration: 235 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000235)= 0.000000000000000E+00 beta (00000235)= 0.129334055969433E+02 gamma(00000235)= 0.129334055969433E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 236 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.4E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000236)= 0.000000000000000E+00 beta (00000236)= 0.133542489601928E+02 gamma(00000236)= 0.133542489601928E+02 z1= 1 0.409465907460008E-06 0.000000000000000E+00 z1= 2 -0.184762619400849E-02 0.000000000000000E+00 z1= 3 -0.510488853099067E-07 0.000000000000000E+00 Lanczos iteration: 237 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000237)= 0.000000000000000E+00 beta (00000237)= 0.126965982857146E+02 gamma(00000237)= 0.126965982857146E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 238 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.4E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000238)= 0.000000000000000E+00 beta (00000238)= 0.136537056528017E+02 gamma(00000238)= 0.136537056528017E+02 z1= 1 -0.396385296033740E-06 0.000000000000000E+00 z1= 2 0.171964244198336E-02 0.000000000000000E+00 z1= 3 0.497352766752786E-07 0.000000000000000E+00 Lanczos iteration: 239 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000239)= 0.000000000000000E+00 beta (00000239)= 0.130073118643607E+02 gamma(00000239)= 0.130073118643607E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 240 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.7E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000240)= 0.000000000000000E+00 beta (00000240)= 0.130840463329228E+02 gamma(00000240)= 0.130840463329228E+02 z1= 1 0.410693765383742E-06 0.000000000000000E+00 z1= 2 -0.170808269139645E-02 0.000000000000000E+00 z1= 3 -0.521633485273641E-07 0.000000000000000E+00 Lanczos iteration: 241 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000241)= 0.000000000000000E+00 beta (00000241)= 0.124579580689658E+02 gamma(00000241)= 0.124579580689658E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 242 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.4E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000242)= 0.000000000000000E+00 beta (00000242)= 0.133028332712344E+02 gamma(00000242)= 0.133028332712344E+02 z1= 1 -0.399590338248873E-06 0.000000000000000E+00 z1= 2 0.159877134659559E-02 0.000000000000000E+00 z1= 3 0.523074617492356E-07 0.000000000000000E+00 Lanczos iteration: 243 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000243)= 0.000000000000000E+00 beta (00000243)= 0.126349083877985E+02 gamma(00000243)= 0.126349083877985E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 244 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.7E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000244)= 0.000000000000000E+00 beta (00000244)= 0.133264971303477E+02 gamma(00000244)= 0.133264971303477E+02 z1= 1 0.391798456907773E-06 0.000000000000000E+00 z1= 2 -0.151183783768265E-02 0.000000000000000E+00 z1= 3 -0.526953876566968E-07 0.000000000000000E+00 Lanczos iteration: 245 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000245)= 0.000000000000000E+00 beta (00000245)= 0.128796196742463E+02 gamma(00000245)= 0.128796196742463E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 246 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000246)= 0.000000000000000E+00 beta (00000246)= 0.135454286638699E+02 gamma(00000246)= 0.135454286638699E+02 z1= 1 -0.383021957537418E-06 0.000000000000000E+00 z1= 2 0.143463382083946E-02 0.000000000000000E+00 z1= 3 0.527791069225916E-07 0.000000000000000E+00 Lanczos iteration: 247 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000247)= 0.000000000000000E+00 beta (00000247)= 0.128870383070663E+02 gamma(00000247)= 0.128870383070663E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 248 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000248)= 0.000000000000000E+00 beta (00000248)= 0.131514252702589E+02 gamma(00000248)= 0.131514252702589E+02 z1= 1 0.385838830538332E-06 0.000000000000000E+00 z1= 2 -0.139924946539884E-02 0.000000000000000E+00 z1= 3 -0.539196573362544E-07 0.000000000000000E+00 Lanczos iteration: 249 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000249)= 0.000000000000000E+00 beta (00000249)= 0.127341510453778E+02 gamma(00000249)= 0.127341510453778E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 250 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000250)= 0.000000000000000E+00 beta (00000250)= 0.135614114163972E+02 gamma(00000250)= 0.135614114163972E+02 z1= 1 -0.371905083004082E-06 0.000000000000000E+00 z1= 2 0.130895058898451E-02 0.000000000000000E+00 z1= 3 0.537898773278998E-07 0.000000000000000E+00 Lanczos iteration: 251 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000251)= 0.000000000000000E+00 beta (00000251)= 0.125569752318488E+02 gamma(00000251)= 0.125569752318488E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 252 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000252)= 0.000000000000000E+00 beta (00000252)= 0.131792359322912E+02 gamma(00000252)= 0.131792359322912E+02 z1= 1 0.363352030762366E-06 0.000000000000000E+00 z1= 2 -0.123780888481960E-02 0.000000000000000E+00 z1= 3 -0.556830628798029E-07 0.000000000000000E+00 Lanczos iteration: 253 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000253)= 0.000000000000000E+00 beta (00000253)= 0.129206046998973E+02 gamma(00000253)= 0.129206046998973E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 254 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000254)= 0.000000000000000E+00 beta (00000254)= 0.133357061170943E+02 gamma(00000254)= 0.133357061170943E+02 z1= 1 -0.358781382457651E-06 0.000000000000000E+00 z1= 2 0.119070930118253E-02 0.000000000000000E+00 z1= 3 0.597460709916148E-07 0.000000000000000E+00 Lanczos iteration: 255 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000255)= 0.000000000000000E+00 beta (00000255)= 0.128066048376786E+02 gamma(00000255)= 0.128066048376786E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 256 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000256)= 0.000000000000000E+00 beta (00000256)= 0.136597212255433E+02 gamma(00000256)= 0.136597212255433E+02 z1= 1 0.342775098084204E-06 0.000000000000000E+00 z1= 2 -0.110396027025651E-02 0.000000000000000E+00 z1= 3 -0.609970616455638E-07 0.000000000000000E+00 Lanczos iteration: 257 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000257)= 0.000000000000000E+00 beta (00000257)= 0.125704867815437E+02 gamma(00000257)= 0.125704867815437E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 258 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.4E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000258)= 0.000000000000000E+00 beta (00000258)= 0.131199113235798E+02 gamma(00000258)= 0.131199113235798E+02 z1= 1 -0.336217771956804E-06 0.000000000000000E+00 z1= 2 0.104484949093578E-02 0.000000000000000E+00 z1= 3 0.622578446764915E-07 0.000000000000000E+00 Lanczos iteration: 259 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000259)= 0.000000000000000E+00 beta (00000259)= 0.124011033263587E+02 gamma(00000259)= 0.124011033263587E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 260 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.5E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000260)= 0.000000000000000E+00 beta (00000260)= 0.132971477369667E+02 gamma(00000260)= 0.132971477369667E+02 z1= 1 0.320583800971809E-06 0.000000000000000E+00 z1= 2 -0.958234141518861E-03 0.000000000000000E+00 z1= 3 -0.601481713966706E-07 0.000000000000000E+00 Lanczos iteration: 261 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000261)= 0.000000000000000E+00 beta (00000261)= 0.127730728481591E+02 gamma(00000261)= 0.127730728481591E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 262 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.6E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000262)= 0.000000000000000E+00 beta (00000262)= 0.132798099196459E+02 gamma(00000262)= 0.132798099196459E+02 z1= 1 -0.313577646291092E-06 0.000000000000000E+00 z1= 2 0.906418746546300E-03 0.000000000000000E+00 z1= 3 0.606973808419536E-07 0.000000000000000E+00 Lanczos iteration: 263 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000263)= 0.000000000000000E+00 beta (00000263)= 0.126525189745534E+02 gamma(00000263)= 0.126525189745534E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 264 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.9E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000264)= 0.000000000000000E+00 beta (00000264)= 0.136137360024608E+02 gamma(00000264)= 0.136137360024608E+02 z1= 1 0.297201833310713E-06 0.000000000000000E+00 z1= 2 -0.825291234664224E-03 0.000000000000000E+00 z1= 3 -0.596887729823956E-07 0.000000000000000E+00 Lanczos iteration: 265 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000265)= 0.000000000000000E+00 beta (00000265)= 0.127956481497637E+02 gamma(00000265)= 0.127956481497637E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 266 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.0E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000266)= 0.000000000000000E+00 beta (00000266)= 0.132562278314010E+02 gamma(00000266)= 0.132562278314010E+02 z1= 1 -0.292961493005266E-06 0.000000000000000E+00 z1= 2 0.780092025364484E-03 0.000000000000000E+00 z1= 3 0.617484421086209E-07 0.000000000000000E+00 Lanczos iteration: 267 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000267)= 0.000000000000000E+00 beta (00000267)= 0.121816186088959E+02 gamma(00000267)= 0.121816186088959E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 268 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.8E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000268)= 0.000000000000000E+00 beta (00000268)= 0.130493732855374E+02 gamma(00000268)= 0.130493732855374E+02 z1= 1 0.280250513439275E-06 0.000000000000000E+00 z1= 2 -0.708865103932237E-03 0.000000000000000E+00 z1= 3 -0.610948827175530E-07 0.000000000000000E+00 Lanczos iteration: 269 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000269)= 0.000000000000000E+00 beta (00000269)= 0.126889934645699E+02 gamma(00000269)= 0.126889934645699E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 270 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.5E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000270)= 0.000000000000000E+00 beta (00000270)= 0.132863295410008E+02 gamma(00000270)= 0.132863295410008E+02 z1= 1 -0.274625106371374E-06 0.000000000000000E+00 z1= 2 0.661518434002521E-03 0.000000000000000E+00 z1= 3 0.611981653365554E-07 0.000000000000000E+00 Lanczos iteration: 271 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000271)= 0.000000000000000E+00 beta (00000271)= 0.125021748784599E+02 gamma(00000271)= 0.125021748784599E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 272 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000272)= 0.000000000000000E+00 beta (00000272)= 0.134831566768326E+02 gamma(00000272)= 0.134831566768326E+02 z1= 1 0.263415473251635E-06 0.000000000000000E+00 z1= 2 -0.594545291912690E-03 0.000000000000000E+00 z1= 3 -0.600576805109441E-07 0.000000000000000E+00 Lanczos iteration: 273 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000273)= 0.000000000000000E+00 beta (00000273)= 0.127019620667483E+02 gamma(00000273)= 0.127019620667483E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 274 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000274)= 0.000000000000000E+00 beta (00000274)= 0.128550859665846E+02 gamma(00000274)= 0.128550859665846E+02 z1= 1 -0.270069367103339E-06 0.000000000000000E+00 z1= 2 0.573825251737676E-03 0.000000000000000E+00 z1= 3 0.627136355942223E-07 0.000000000000000E+00 Lanczos iteration: 275 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000275)= 0.000000000000000E+00 beta (00000275)= 0.130646964745168E+02 gamma(00000275)= 0.130646964745168E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 276 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000276)= 0.000000000000000E+00 beta (00000276)= 0.128779991373549E+02 gamma(00000276)= 0.128779991373549E+02 z1= 1 0.285096101879535E-06 0.000000000000000E+00 z1= 2 -0.563814087514505E-03 0.000000000000000E+00 z1= 3 -0.665517447834968E-07 0.000000000000000E+00 Lanczos iteration: 277 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000277)= 0.000000000000000E+00 beta (00000277)= 0.124224664532571E+02 gamma(00000277)= 0.124224664532571E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 278 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000278)= 0.000000000000000E+00 beta (00000278)= 0.135504096380083E+02 gamma(00000278)= 0.135504096380083E+02 z1= 1 -0.273140566882206E-06 0.000000000000000E+00 z1= 2 0.510825028406537E-03 0.000000000000000E+00 z1= 3 0.634529930827309E-07 0.000000000000000E+00 Lanczos iteration: 279 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000279)= 0.000000000000000E+00 beta (00000279)= 0.123030048507094E+02 gamma(00000279)= 0.123030048507094E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 280 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000280)= 0.000000000000000E+00 beta (00000280)= 0.134863995585226E+02 gamma(00000280)= 0.134863995585226E+02 z1= 1 0.263068552403684E-06 0.000000000000000E+00 z1= 2 -0.448427271869438E-03 0.000000000000000E+00 z1= 3 -0.606644917568351E-07 0.000000000000000E+00 Lanczos iteration: 281 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000281)= 0.000000000000000E+00 beta (00000281)= 0.130778370072719E+02 gamma(00000281)= 0.130778370072719E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 282 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000282)= 0.000000000000000E+00 beta (00000282)= 0.136188056161799E+02 gamma(00000282)= 0.136188056161799E+02 z1= 1 -0.266906742351410E-06 0.000000000000000E+00 z1= 2 0.431397368303103E-03 0.000000000000000E+00 z1= 3 0.618889517737219E-07 0.000000000000000E+00 Lanczos iteration: 283 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000283)= 0.000000000000000E+00 beta (00000283)= 0.130416867455413E+02 gamma(00000283)= 0.130416867455413E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 284 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.7E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000284)= 0.000000000000000E+00 beta (00000284)= 0.133006683585719E+02 gamma(00000284)= 0.133006683585719E+02 z1= 1 0.278324056356659E-06 0.000000000000000E+00 z1= 2 -0.405808393129203E-03 0.000000000000000E+00 z1= 3 -0.650292794283219E-07 0.000000000000000E+00 Lanczos iteration: 285 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000285)= 0.000000000000000E+00 beta (00000285)= 0.126712352338880E+02 gamma(00000285)= 0.126712352338880E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 286 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000286)= 0.000000000000000E+00 beta (00000286)= 0.136988370543259E+02 gamma(00000286)= 0.136988370543259E+02 z1= 1 -0.272399406127041E-06 0.000000000000000E+00 z1= 2 0.380055076734769E-03 0.000000000000000E+00 z1= 3 0.650152918988713E-07 0.000000000000000E+00 Lanczos iteration: 287 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000287)= 0.000000000000000E+00 beta (00000287)= 0.123645779476215E+02 gamma(00000287)= 0.123645779476215E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 288 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000288)= 0.000000000000000E+00 beta (00000288)= 0.137990168171186E+02 gamma(00000288)= 0.137990168171186E+02 z1= 1 0.260649219318253E-06 0.000000000000000E+00 z1= 2 -0.326751953337187E-03 0.000000000000000E+00 z1= 3 -0.628769452983881E-07 0.000000000000000E+00 Lanczos iteration: 289 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000289)= 0.000000000000000E+00 beta (00000289)= 0.128376610051242E+02 gamma(00000289)= 0.128376610051242E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 290 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.4E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000290)= 0.000000000000000E+00 beta (00000290)= 0.132655971374718E+02 gamma(00000290)= 0.132655971374718E+02 z1= 1 -0.266714593853776E-06 0.000000000000000E+00 z1= 2 0.323347449230939E-03 0.000000000000000E+00 z1= 3 0.658562058241698E-07 0.000000000000000E+00 Lanczos iteration: 291 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000291)= 0.000000000000000E+00 beta (00000291)= 0.131213339673001E+02 gamma(00000291)= 0.131213339673001E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 292 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.6E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000292)= 0.000000000000000E+00 beta (00000292)= 0.133875600150794E+02 gamma(00000292)= 0.133875600150794E+02 z1= 1 0.275664540258427E-06 0.000000000000000E+00 z1= 2 -0.306399515864361E-03 0.000000000000000E+00 z1= 3 -0.693218297556641E-07 0.000000000000000E+00 Lanczos iteration: 293 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000293)= 0.000000000000000E+00 beta (00000293)= 0.123756693075021E+02 gamma(00000293)= 0.123756693075021E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 294 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.2E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000294)= 0.000000000000000E+00 beta (00000294)= 0.136517065307276E+02 gamma(00000294)= 0.136517065307276E+02 z1= 1 -0.263274584042916E-06 0.000000000000000E+00 z1= 2 0.285791042444156E-03 0.000000000000000E+00 z1= 3 0.678163363254398E-07 0.000000000000000E+00 Lanczos iteration: 295 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000295)= 0.000000000000000E+00 beta (00000295)= 0.126581567471615E+02 gamma(00000295)= 0.126581567471615E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 296 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.8E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000296)= 0.000000000000000E+00 beta (00000296)= 0.135638029333767E+02 gamma(00000296)= 0.135638029333767E+02 z1= 1 0.261130061904487E-06 0.000000000000000E+00 z1= 2 -0.260366411601008E-03 0.000000000000000E+00 z1= 3 -0.686712969426078E-07 0.000000000000000E+00 Lanczos iteration: 297 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000297)= 0.000000000000000E+00 beta (00000297)= 0.131901196649296E+02 gamma(00000297)= 0.131901196649296E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 298 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000298)= 0.000000000000000E+00 beta (00000298)= 0.131222454000737E+02 gamma(00000298)= 0.131222454000737E+02 z1= 1 -0.277813433497125E-06 0.000000000000000E+00 z1= 2 0.269885966514852E-03 0.000000000000000E+00 z1= 3 0.760554136796168E-07 0.000000000000000E+00 Lanczos iteration: 299 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000299)= 0.000000000000000E+00 beta (00000299)= 0.129072917441543E+02 gamma(00000299)= 0.129072917441543E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 300 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000300)= 0.000000000000000E+00 beta (00000300)= 0.129072917782645E+02 gamma(00000300)= 0.129072917782645E+02 z1= 1 0.294096863114827E-06 0.000000000000000E+00 z1= 2 -0.268800919399664E-03 0.000000000000000E+00 z1= 3 -0.835360209859581E-07 0.000000000000000E+00 Lanczos iteration: 301 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000301)= 0.000000000000000E+00 beta (00000301)= 0.129078618088992E+02 gamma(00000301)= 0.129078618088992E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 302 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000302)= 0.000000000000000E+00 beta (00000302)= 0.129700399522570E+02 gamma(00000302)= 0.129700399522570E+02 z1= 1 -0.307899598217705E-06 0.000000000000000E+00 z1= 2 0.276306917746112E-03 0.000000000000000E+00 z1= 3 0.909167498261247E-07 0.000000000000000E+00 Lanczos iteration: 303 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000303)= 0.000000000000000E+00 beta (00000303)= 0.123952964570594E+02 gamma(00000303)= 0.123952964570594E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 304 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000304)= 0.000000000000000E+00 beta (00000304)= 0.134435003629024E+02 gamma(00000304)= 0.134435003629024E+02 z1= 1 0.298800519048107E-06 0.000000000000000E+00 z1= 2 -0.259784349187206E-03 0.000000000000000E+00 z1= 3 -0.917257267531841E-07 0.000000000000000E+00 Lanczos iteration: 305 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000305)= 0.000000000000000E+00 beta (00000305)= 0.128209411073698E+02 gamma(00000305)= 0.128209411073698E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 306 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000306)= 0.000000000000000E+00 beta (00000306)= 0.130838867812178E+02 gamma(00000306)= 0.130838867812178E+02 z1= 1 -0.306209269715970E-06 0.000000000000000E+00 z1= 2 0.265644582963367E-03 0.000000000000000E+00 z1= 3 0.993103495560994E-07 0.000000000000000E+00 Lanczos iteration: 307 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000307)= 0.000000000000000E+00 beta (00000307)= 0.126539839847517E+02 gamma(00000307)= 0.126539839847517E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 308 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.7E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000308)= 0.000000000000000E+00 beta (00000308)= 0.133764537549789E+02 gamma(00000308)= 0.133764537549789E+02 z1= 1 0.302818040159251E-06 0.000000000000000E+00 z1= 2 -0.259825453987849E-03 0.000000000000000E+00 z1= 3 -0.102702851586969E-06 0.000000000000000E+00 Lanczos iteration: 309 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000309)= 0.000000000000000E+00 beta (00000309)= 0.126728768493451E+02 gamma(00000309)= 0.126728768493451E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 310 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000310)= 0.000000000000000E+00 beta (00000310)= 0.134248062164561E+02 gamma(00000310)= 0.134248062164561E+02 z1= 1 -0.298831422258870E-06 0.000000000000000E+00 z1= 2 0.256980284701881E-03 0.000000000000000E+00 z1= 3 0.106289310271204E-06 0.000000000000000E+00 Lanczos iteration: 311 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000311)= 0.000000000000000E+00 beta (00000311)= 0.124223473465250E+02 gamma(00000311)= 0.124223473465250E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 312 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.3E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000312)= 0.000000000000000E+00 beta (00000312)= 0.134670221016656E+02 gamma(00000312)= 0.134670221016656E+02 z1= 1 0.290424376696991E-06 0.000000000000000E+00 z1= 2 -0.248320014998162E-03 0.000000000000000E+00 z1= 3 -0.107698315003916E-06 0.000000000000000E+00 Lanczos iteration: 313 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000313)= 0.000000000000000E+00 beta (00000313)= 0.129851937739604E+02 gamma(00000313)= 0.129851937739604E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 314 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.4E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000314)= 0.000000000000000E+00 beta (00000314)= 0.133806601163172E+02 gamma(00000314)= 0.133806601163172E+02 z1= 1 -0.296528444858508E-06 0.000000000000000E+00 z1= 2 0.254029017098603E-03 0.000000000000000E+00 z1= 3 0.113922581344888E-06 0.000000000000000E+00 Lanczos iteration: 315 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000315)= 0.000000000000000E+00 beta (00000315)= 0.128244272871223E+02 gamma(00000315)= 0.128244272871223E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 316 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.4E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000316)= 0.000000000000000E+00 beta (00000316)= 0.135296770176599E+02 gamma(00000316)= 0.135296770176599E+02 z1= 1 0.295550580589783E-06 0.000000000000000E+00 z1= 2 -0.254643258212804E-03 0.000000000000000E+00 z1= 3 -0.117318619507513E-06 0.000000000000000E+00 Lanczos iteration: 317 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000317)= 0.000000000000000E+00 beta (00000317)= 0.125397401114779E+02 gamma(00000317)= 0.125397401114779E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 318 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.3E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000318)= 0.000000000000000E+00 beta (00000318)= 0.130734077815282E+02 gamma(00000318)= 0.130734077815282E+02 z1= 1 -0.298722883448552E-06 0.000000000000000E+00 z1= 2 0.258898193400900E-03 0.000000000000000E+00 z1= 3 0.123294085100333E-06 0.000000000000000E+00 Lanczos iteration: 319 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000319)= 0.000000000000000E+00 beta (00000319)= 0.121740934871683E+02 gamma(00000319)= 0.121740934871683E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 320 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000320)= 0.000000000000000E+00 beta (00000320)= 0.133207450359047E+02 gamma(00000320)= 0.133207450359047E+02 z1= 1 0.289649248473231E-06 0.000000000000000E+00 z1= 2 -0.255776273717877E-03 0.000000000000000E+00 z1= 3 -0.123438066789751E-06 0.000000000000000E+00 Lanczos iteration: 321 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000321)= 0.000000000000000E+00 beta (00000321)= 0.125328806025250E+02 gamma(00000321)= 0.125328806025250E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 322 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.1E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000322)= 0.000000000000000E+00 beta (00000322)= 0.134875299358435E+02 gamma(00000322)= 0.134875299358435E+02 z1= 1 -0.283944913944192E-06 0.000000000000000E+00 z1= 2 0.253580476228622E-03 0.000000000000000E+00 z1= 3 0.125422865153825E-06 0.000000000000000E+00 Lanczos iteration: 323 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000323)= 0.000000000000000E+00 beta (00000323)= 0.126350062903104E+02 gamma(00000323)= 0.126350062903104E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 324 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.1E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000324)= 0.000000000000000E+00 beta (00000324)= 0.132959501897002E+02 gamma(00000324)= 0.132959501897002E+02 z1= 1 0.284746279976753E-06 0.000000000000000E+00 z1= 2 -0.266964158909457E-03 0.000000000000000E+00 z1= 3 -0.129603977263139E-06 0.000000000000000E+00 Lanczos iteration: 325 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000325)= 0.000000000000000E+00 beta (00000325)= 0.126786848074282E+02 gamma(00000325)= 0.126786848074282E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 326 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000326)= 0.000000000000000E+00 beta (00000326)= 0.135699021460185E+02 gamma(00000326)= 0.135699021460185E+02 z1= 1 -0.276579320683881E-06 0.000000000000000E+00 z1= 2 0.265434900069401E-03 0.000000000000000E+00 z1= 3 0.130673093909914E-06 0.000000000000000E+00 Lanczos iteration: 327 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000327)= 0.000000000000000E+00 beta (00000327)= 0.126413455377507E+02 gamma(00000327)= 0.126413455377507E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 328 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000328)= 0.000000000000000E+00 beta (00000328)= 0.132477880975717E+02 gamma(00000328)= 0.132477880975717E+02 z1= 1 0.276051652836964E-06 0.000000000000000E+00 z1= 2 -0.287566613177829E-03 0.000000000000000E+00 z1= 3 -0.134662175158831E-06 0.000000000000000E+00 Lanczos iteration: 329 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000329)= 0.000000000000000E+00 beta (00000329)= 0.124536448421844E+02 gamma(00000329)= 0.124536448421844E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 330 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000330)= 0.000000000000000E+00 beta (00000330)= 0.134732065244896E+02 gamma(00000330)= 0.134732065244896E+02 z1= 1 -0.262499014955231E-06 0.000000000000000E+00 z1= 2 0.282309226920895E-03 0.000000000000000E+00 z1= 3 0.135620855962627E-06 0.000000000000000E+00 Lanczos iteration: 331 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000331)= 0.000000000000000E+00 beta (00000331)= 0.129160278806059E+02 gamma(00000331)= 0.129160278806059E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 332 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.0E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000332)= 0.000000000000000E+00 beta (00000332)= 0.134153323276093E+02 gamma(00000332)= 0.134153323276093E+02 z1= 1 0.262521960232853E-06 0.000000000000000E+00 z1= 2 -0.313939950388592E-03 0.000000000000000E+00 z1= 3 -0.142242508165743E-06 0.000000000000000E+00 Lanczos iteration: 333 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000333)= 0.000000000000000E+00 beta (00000333)= 0.131687448701298E+02 gamma(00000333)= 0.131687448701298E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 334 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.7E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000334)= 0.000000000000000E+00 beta (00000334)= 0.133883463593471E+02 gamma(00000334)= 0.133883463593471E+02 z1= 1 -0.263702495089356E-06 0.000000000000000E+00 z1= 2 0.320705814227050E-03 0.000000000000000E+00 z1= 3 0.150987045084965E-06 0.000000000000000E+00 Lanczos iteration: 335 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000335)= 0.000000000000000E+00 beta (00000335)= 0.124019520405808E+02 gamma(00000335)= 0.124019520405808E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 336 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000336)= 0.000000000000000E+00 beta (00000336)= 0.129877038231613E+02 gamma(00000336)= 0.129877038231613E+02 z1= 1 0.259690333787380E-06 0.000000000000000E+00 z1= 2 -0.351741724114777E-03 0.000000000000000E+00 z1= 3 -0.156164195674489E-06 0.000000000000000E+00 Lanczos iteration: 337 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000337)= 0.000000000000000E+00 beta (00000337)= 0.126220592221458E+02 gamma(00000337)= 0.126220592221458E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 338 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000338)= 0.000000000000000E+00 beta (00000338)= 0.135909606807732E+02 gamma(00000338)= 0.135909606807732E+02 z1= 1 -0.241799950027877E-06 0.000000000000000E+00 z1= 2 0.332018822997117E-03 0.000000000000000E+00 z1= 3 0.154489865003202E-06 0.000000000000000E+00 Lanczos iteration: 339 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000339)= 0.000000000000000E+00 beta (00000339)= 0.124348159019735E+02 gamma(00000339)= 0.124348159019735E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 340 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000340)= 0.000000000000000E+00 beta (00000340)= 0.134234305114552E+02 gamma(00000340)= 0.134234305114552E+02 z1= 1 0.228994798285101E-06 0.000000000000000E+00 z1= 2 -0.358776167143959E-03 0.000000000000000E+00 z1= 3 -0.154231553243416E-06 0.000000000000000E+00 Lanczos iteration: 341 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000341)= 0.000000000000000E+00 beta (00000341)= 0.127741663590408E+02 gamma(00000341)= 0.127741663590408E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 342 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000342)= 0.000000000000000E+00 beta (00000342)= 0.134430707870502E+02 gamma(00000342)= 0.134430707870502E+02 z1= 1 -0.214516236225759E-06 0.000000000000000E+00 z1= 2 0.333281985744218E-03 0.000000000000000E+00 z1= 3 0.156756232056647E-06 0.000000000000000E+00 Lanczos iteration: 343 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000343)= 0.000000000000000E+00 beta (00000343)= 0.124269129556179E+02 gamma(00000343)= 0.124269129556179E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 344 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000344)= 0.000000000000000E+00 beta (00000344)= 0.138308314921421E+02 gamma(00000344)= 0.138308314921421E+02 z1= 1 0.196569833012424E-06 0.000000000000000E+00 z1= 2 -0.357619981365457E-03 0.000000000000000E+00 z1= 3 -0.154137275520634E-06 0.000000000000000E+00 Lanczos iteration: 345 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000345)= 0.000000000000000E+00 beta (00000345)= 0.130374523711965E+02 gamma(00000345)= 0.130374523711965E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 346 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000346)= 0.000000000000000E+00 beta (00000346)= 0.136619145236524E+02 gamma(00000346)= 0.136619145236524E+02 z1= 1 -0.180862200099092E-06 0.000000000000000E+00 z1= 2 0.319337316600649E-03 0.000000000000000E+00 z1= 3 0.158591455556509E-06 0.000000000000000E+00 Lanczos iteration: 347 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000347)= 0.000000000000000E+00 beta (00000347)= 0.126952766783605E+02 gamma(00000347)= 0.126952766783605E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 348 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000348)= 0.000000000000000E+00 beta (00000348)= 0.136501047973107E+02 gamma(00000348)= 0.136501047973107E+02 z1= 1 0.169589449855521E-06 0.000000000000000E+00 z1= 2 -0.354868394244288E-03 0.000000000000000E+00 z1= 3 -0.162437170036231E-06 0.000000000000000E+00 Lanczos iteration: 349 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000349)= 0.000000000000000E+00 beta (00000349)= 0.129398369021750E+02 gamma(00000349)= 0.129398369021750E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 350 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000350)= 0.000000000000000E+00 beta (00000350)= 0.133042797156658E+02 gamma(00000350)= 0.133042797156658E+02 z1= 1 -0.156141691335168E-06 0.000000000000000E+00 z1= 2 0.326624656691209E-03 0.000000000000000E+00 z1= 3 0.170921326431888E-06 0.000000000000000E+00 Lanczos iteration: 351 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000351)= 0.000000000000000E+00 beta (00000351)= 0.126895330232839E+02 gamma(00000351)= 0.126895330232839E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 352 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.2E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000352)= 0.000000000000000E+00 beta (00000352)= 0.131166554694867E+02 gamma(00000352)= 0.131166554694867E+02 z1= 1 0.150035084300025E-06 0.000000000000000E+00 z1= 2 -0.361049325170308E-03 0.000000000000000E+00 z1= 3 -0.181124543777774E-06 0.000000000000000E+00 Lanczos iteration: 353 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000353)= 0.000000000000000E+00 beta (00000353)= 0.131365140598382E+02 gamma(00000353)= 0.131365140598382E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 354 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000354)= 0.000000000000000E+00 beta (00000354)= 0.131768003967311E+02 gamma(00000354)= 0.131768003967311E+02 z1= 1 -0.142226530937956E-06 0.000000000000000E+00 z1= 2 0.348503623413662E-03 0.000000000000000E+00 z1= 3 0.195274565192990E-06 0.000000000000000E+00 Lanczos iteration: 355 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000355)= 0.000000000000000E+00 beta (00000355)= 0.126605992154712E+02 gamma(00000355)= 0.126605992154712E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 356 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000356)= 0.000000000000000E+00 beta (00000356)= 0.134015684246068E+02 gamma(00000356)= 0.134015684246068E+02 z1= 1 0.133989588363762E-06 0.000000000000000E+00 z1= 2 -0.357478281363043E-03 0.000000000000000E+00 z1= 3 -0.199604873106019E-06 0.000000000000000E+00 Lanczos iteration: 357 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000357)= 0.000000000000000E+00 beta (00000357)= 0.126672205772826E+02 gamma(00000357)= 0.126672205772826E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 358 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000358)= 0.000000000000000E+00 beta (00000358)= 0.134009129540686E+02 gamma(00000358)= 0.134009129540686E+02 z1= 1 -0.121956820222507E-06 0.000000000000000E+00 z1= 2 0.331458333264748E-03 0.000000000000000E+00 z1= 3 0.203825631731871E-06 0.000000000000000E+00 Lanczos iteration: 359 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000359)= 0.000000000000000E+00 beta (00000359)= 0.125905962085431E+02 gamma(00000359)= 0.125905962085431E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 360 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000360)= 0.000000000000000E+00 beta (00000360)= 0.134398746285364E+02 gamma(00000360)= 0.134398746285364E+02 z1= 1 0.114414972865809E-06 0.000000000000000E+00 z1= 2 -0.325924866904267E-03 0.000000000000000E+00 z1= 3 -0.205297098100003E-06 0.000000000000000E+00 Lanczos iteration: 361 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000361)= 0.000000000000000E+00 beta (00000361)= 0.122152685016261E+02 gamma(00000361)= 0.122152685016261E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 362 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000362)= 0.000000000000000E+00 beta (00000362)= 0.132245813115787E+02 gamma(00000362)= 0.132245813115787E+02 z1= 1 -0.102700860843408E-06 0.000000000000000E+00 z1= 2 0.297995802873737E-03 0.000000000000000E+00 z1= 3 0.204822689447233E-06 0.000000000000000E+00 Lanczos iteration: 363 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000363)= 0.000000000000000E+00 beta (00000363)= 0.124894962186906E+02 gamma(00000363)= 0.124894962186906E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 364 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.6E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000364)= 0.000000000000000E+00 beta (00000364)= 0.132936650174506E+02 gamma(00000364)= 0.132936650174506E+02 z1= 1 0.972378045652200E-07 0.000000000000000E+00 z1= 2 -0.287081993827885E-03 0.000000000000000E+00 z1= 3 -0.209908353040095E-06 0.000000000000000E+00 Lanczos iteration: 365 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000365)= 0.000000000000000E+00 beta (00000365)= 0.126231281087887E+02 gamma(00000365)= 0.126231281087887E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 366 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.9E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000366)= 0.000000000000000E+00 beta (00000366)= 0.129059161799301E+02 gamma(00000366)= 0.129059161799301E+02 z1= 1 -0.926188605376160E-07 0.000000000000000E+00 z1= 2 0.277805151468526E-03 0.000000000000000E+00 z1= 3 0.224380726099468E-06 0.000000000000000E+00 Lanczos iteration: 367 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000367)= 0.000000000000000E+00 beta (00000367)= 0.124422291714153E+02 gamma(00000367)= 0.124422291714153E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 368 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.3E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000368)= 0.000000000000000E+00 beta (00000368)= 0.136426979656567E+02 gamma(00000368)= 0.136426979656567E+02 z1= 1 0.849542361579941E-07 0.000000000000000E+00 z1= 2 -0.254004385138890E-03 0.000000000000000E+00 z1= 3 -0.222210486216265E-06 0.000000000000000E+00 Lanczos iteration: 369 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000369)= 0.000000000000000E+00 beta (00000369)= 0.128093283239716E+02 gamma(00000369)= 0.128093283239716E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 370 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.3E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000370)= 0.000000000000000E+00 beta (00000370)= 0.134556220405534E+02 gamma(00000370)= 0.134556220405534E+02 z1= 1 -0.790071475603726E-07 0.000000000000000E+00 z1= 2 0.236234095793831E-03 0.000000000000000E+00 z1= 3 0.229624619148532E-06 0.000000000000000E+00 Lanczos iteration: 371 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000371)= 0.000000000000000E+00 beta (00000371)= 0.123746935308453E+02 gamma(00000371)= 0.123746935308453E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 372 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.8E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000372)= 0.000000000000000E+00 beta (00000372)= 0.131576351551664E+02 gamma(00000372)= 0.131576351551664E+02 z1= 1 0.783424735327498E-07 0.000000000000000E+00 z1= 2 -0.218166721213324E-03 0.000000000000000E+00 z1= 3 -0.235738720871922E-06 0.000000000000000E+00 Lanczos iteration: 373 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000373)= 0.000000000000000E+00 beta (00000373)= 0.127721739192232E+02 gamma(00000373)= 0.127721739192232E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 374 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.4E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000374)= 0.000000000000000E+00 beta (00000374)= 0.136706042264499E+02 gamma(00000374)= 0.136706042264499E+02 z1= 1 -0.733978390895368E-07 0.000000000000000E+00 z1= 2 0.197691075217466E-03 0.000000000000000E+00 z1= 3 0.238435913132908E-06 0.000000000000000E+00 Lanczos iteration: 375 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000375)= 0.000000000000000E+00 beta (00000375)= 0.128191488739654E+02 gamma(00000375)= 0.128191488739654E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 376 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000376)= 0.000000000000000E+00 beta (00000376)= 0.134509966346524E+02 gamma(00000376)= 0.134509966346524E+02 z1= 1 0.755918343007395E-07 0.000000000000000E+00 z1= 2 -0.182699648561518E-03 0.000000000000000E+00 z1= 3 -0.246994590668691E-06 0.000000000000000E+00 Lanczos iteration: 377 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000377)= 0.000000000000000E+00 beta (00000377)= 0.124611955796033E+02 gamma(00000377)= 0.124611955796033E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 378 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.7E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000378)= 0.000000000000000E+00 beta (00000378)= 0.131575834407673E+02 gamma(00000378)= 0.131575834407673E+02 z1= 1 -0.712331328731747E-07 0.000000000000000E+00 z1= 2 0.166890883295311E-03 0.000000000000000E+00 z1= 3 0.255437646061538E-06 0.000000000000000E+00 Lanczos iteration: 379 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000379)= 0.000000000000000E+00 beta (00000379)= 0.124285554743304E+02 gamma(00000379)= 0.124285554743304E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 380 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.7E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000380)= 0.000000000000000E+00 beta (00000380)= 0.131318715221409E+02 gamma(00000380)= 0.131318715221409E+02 z1= 1 0.771231804877481E-07 0.000000000000000E+00 z1= 2 -0.149727349924741E-03 0.000000000000000E+00 z1= 3 -0.264123535519741E-06 0.000000000000000E+00 Lanczos iteration: 381 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000381)= 0.000000000000000E+00 beta (00000381)= 0.126462514817816E+02 gamma(00000381)= 0.126462514817816E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 382 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000382)= 0.000000000000000E+00 beta (00000382)= 0.134598437609138E+02 gamma(00000382)= 0.134598437609138E+02 z1= 1 -0.730841791182768E-07 0.000000000000000E+00 z1= 2 0.135918394599463E-03 0.000000000000000E+00 z1= 3 0.268532245020076E-06 0.000000000000000E+00 Lanczos iteration: 383 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000383)= 0.000000000000000E+00 beta (00000383)= 0.125009543216572E+02 gamma(00000383)= 0.125009543216572E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 384 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000384)= 0.000000000000000E+00 beta (00000384)= 0.131940807887096E+02 gamma(00000384)= 0.131940807887096E+02 z1= 1 0.866577853208400E-07 0.000000000000000E+00 z1= 2 -0.120253027136589E-03 0.000000000000000E+00 z1= 3 -0.276885938142518E-06 0.000000000000000E+00 Lanczos iteration: 385 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000385)= 0.000000000000000E+00 beta (00000385)= 0.125637138989696E+02 gamma(00000385)= 0.125637138989696E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 386 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000386)= 0.000000000000000E+00 beta (00000386)= 0.130278849913394E+02 gamma(00000386)= 0.130278849913394E+02 z1= 1 -0.803857789846707E-07 0.000000000000000E+00 z1= 2 0.114384633655124E-03 0.000000000000000E+00 z1= 3 0.288260445314168E-06 0.000000000000000E+00 Lanczos iteration: 387 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000387)= 0.000000000000000E+00 beta (00000387)= 0.125569098573169E+02 gamma(00000387)= 0.125569098573169E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 388 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.8E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000388)= 0.000000000000000E+00 beta (00000388)= 0.136333721282802E+02 gamma(00000388)= 0.136333721282802E+02 z1= 1 0.995450175553247E-07 0.000000000000000E+00 z1= 2 -0.981180079132893E-04 0.000000000000000E+00 z1= 3 -0.288346655767440E-06 0.000000000000000E+00 Lanczos iteration: 389 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000389)= 0.000000000000000E+00 beta (00000389)= 0.127309205584898E+02 gamma(00000389)= 0.127309205584898E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 390 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.0E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000390)= 0.000000000000000E+00 beta (00000390)= 0.131557603794823E+02 gamma(00000390)= 0.131557603794823E+02 z1= 1 -0.808543884622814E-07 0.000000000000000E+00 z1= 2 0.979864200301613E-04 0.000000000000000E+00 z1= 3 0.301169933563473E-06 0.000000000000000E+00 Lanczos iteration: 391 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000391)= 0.000000000000000E+00 beta (00000391)= 0.127908411004372E+02 gamma(00000391)= 0.127908411004372E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 392 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000392)= 0.000000000000000E+00 beta (00000392)= 0.134330238898530E+02 gamma(00000392)= 0.134330238898530E+02 z1= 1 0.112159385364310E-06 0.000000000000000E+00 z1= 2 -0.861270971699579E-04 0.000000000000000E+00 z1= 3 -0.311109140266720E-06 0.000000000000000E+00 Lanczos iteration: 393 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000393)= 0.000000000000000E+00 beta (00000393)= 0.126880701089769E+02 gamma(00000393)= 0.126880701089769E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 394 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000394)= 0.000000000000000E+00 beta (00000394)= 0.136691609721548E+02 gamma(00000394)= 0.136691609721548E+02 z1= 1 -0.737145827468810E-07 0.000000000000000E+00 z1= 2 0.852051582843696E-04 0.000000000000000E+00 z1= 3 0.309291908441849E-06 0.000000000000000E+00 Lanczos iteration: 395 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000395)= 0.000000000000000E+00 beta (00000395)= 0.125367984110091E+02 gamma(00000395)= 0.125367984110091E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 396 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000396)= 0.000000000000000E+00 beta (00000396)= 0.133089023685172E+02 gamma(00000396)= 0.133089023685172E+02 z1= 1 0.115412959410775E-06 0.000000000000000E+00 z1= 2 -0.704761302659576E-04 0.000000000000000E+00 z1= 3 -0.318757966257053E-06 0.000000000000000E+00 Lanczos iteration: 397 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000397)= 0.000000000000000E+00 beta (00000397)= 0.128652784537180E+02 gamma(00000397)= 0.128652784537180E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 398 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000398)= 0.000000000000000E+00 beta (00000398)= 0.137275129691676E+02 gamma(00000398)= 0.137275129691676E+02 z1= 1 -0.641474807118111E-07 0.000000000000000E+00 z1= 2 0.696073755396161E-04 0.000000000000000E+00 z1= 3 0.320040827916836E-06 0.000000000000000E+00 Lanczos iteration: 399 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000399)= 0.000000000000000E+00 beta (00000399)= 0.123832234766686E+02 gamma(00000399)= 0.123832234766686E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 400 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000400)= 0.000000000000000E+00 beta (00000400)= 0.131534055141405E+02 gamma(00000400)= 0.131534055141405E+02 z1= 1 0.117672736443808E-06 0.000000000000000E+00 z1= 2 -0.508850416803194E-04 0.000000000000000E+00 z1= 3 -0.333983739483467E-06 0.000000000000000E+00 Lanczos iteration: 401 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000401)= 0.000000000000000E+00 beta (00000401)= 0.125258446769910E+02 gamma(00000401)= 0.125258446769910E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 402 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.4E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000402)= 0.000000000000000E+00 beta (00000402)= 0.134806070685621E+02 gamma(00000402)= 0.134806070685621E+02 z1= 1 -0.479889024733449E-07 0.000000000000000E+00 z1= 2 0.466855053132924E-04 0.000000000000000E+00 z1= 3 0.335193230057134E-06 0.000000000000000E+00 Lanczos iteration: 403 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000403)= 0.000000000000000E+00 beta (00000403)= 0.125312653462674E+02 gamma(00000403)= 0.125312653462674E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 404 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.8E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000404)= 0.000000000000000E+00 beta (00000404)= 0.131430423438964E+02 gamma(00000404)= 0.131430423438964E+02 z1= 1 0.133071889348024E-06 0.000000000000000E+00 z1= 2 -0.194747114099624E-04 0.000000000000000E+00 z1= 3 -0.358864382184534E-06 0.000000000000000E+00 Lanczos iteration: 405 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000405)= 0.000000000000000E+00 beta (00000405)= 0.124554917153035E+02 gamma(00000405)= 0.124554917153035E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 406 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.0E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000406)= 0.000000000000000E+00 beta (00000406)= 0.137327777724109E+02 gamma(00000406)= 0.137327777724109E+02 z1= 1 -0.202177461022801E-07 0.000000000000000E+00 z1= 2 0.150772305235174E-04 0.000000000000000E+00 z1= 3 0.350590364473109E-06 0.000000000000000E+00 Lanczos iteration: 407 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000407)= 0.000000000000000E+00 beta (00000407)= 0.125470619589676E+02 gamma(00000407)= 0.125470619589676E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 408 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.9E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000408)= 0.000000000000000E+00 beta (00000408)= 0.131195342477454E+02 gamma(00000408)= 0.131195342477454E+02 z1= 1 0.166219518777516E-06 0.000000000000000E+00 z1= 2 0.254153382799249E-04 0.000000000000000E+00 z1= 3 -0.386123213060204E-06 0.000000000000000E+00 Lanczos iteration: 409 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000409)= 0.000000000000000E+00 beta (00000409)= 0.128856869724072E+02 gamma(00000409)= 0.128856869724072E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 410 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.7E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000410)= 0.000000000000000E+00 beta (00000410)= 0.136006867758951E+02 gamma(00000410)= 0.136006867758951E+02 z1= 1 0.139085659794924E-07 0.000000000000000E+00 z1= 2 -0.245051048721624E-04 0.000000000000000E+00 z1= 3 0.390499137763092E-06 0.000000000000000E+00 Lanczos iteration: 411 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000411)= 0.000000000000000E+00 beta (00000411)= 0.126834476504954E+02 gamma(00000411)= 0.126834476504954E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 412 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.3E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000412)= 0.000000000000000E+00 beta (00000412)= 0.135090796684927E+02 gamma(00000412)= 0.135090796684927E+02 z1= 1 0.201870535885586E-06 0.000000000000000E+00 z1= 2 0.765027605704217E-04 0.000000000000000E+00 z1= 3 -0.425406534332318E-06 0.000000000000000E+00 Lanczos iteration: 413 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000413)= 0.000000000000000E+00 beta (00000413)= 0.127179595512943E+02 gamma(00000413)= 0.127179595512943E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 414 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000414)= 0.000000000000000E+00 beta (00000414)= 0.138185093316382E+02 gamma(00000414)= 0.138185093316382E+02 z1= 1 0.406980751660110E-07 0.000000000000000E+00 z1= 2 -0.691628591241809E-04 0.000000000000000E+00 z1= 3 0.414365819317343E-06 0.000000000000000E+00 Lanczos iteration: 415 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000415)= 0.000000000000000E+00 beta (00000415)= 0.127185459714479E+02 gamma(00000415)= 0.127185459714479E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 416 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000416)= 0.000000000000000E+00 beta (00000416)= 0.134186628456889E+02 gamma(00000416)= 0.134186628456889E+02 z1= 1 0.211195299121454E-06 0.000000000000000E+00 z1= 2 0.129399519194186E-03 0.000000000000000E+00 z1= 3 -0.458355152077507E-06 0.000000000000000E+00 Lanczos iteration: 417 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000417)= 0.000000000000000E+00 beta (00000417)= 0.125869923702600E+02 gamma(00000417)= 0.125869923702600E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 418 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000418)= 0.000000000000000E+00 beta (00000418)= 0.135723977779467E+02 gamma(00000418)= 0.135723977779467E+02 z1= 1 0.427211141280567E-07 0.000000000000000E+00 z1= 2 -0.123280915678749E-03 0.000000000000000E+00 z1= 3 0.451287144933969E-06 0.000000000000000E+00 Lanczos iteration: 419 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000419)= 0.000000000000000E+00 beta (00000419)= 0.130797629634495E+02 gamma(00000419)= 0.130797629634495E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 420 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000420)= 0.000000000000000E+00 beta (00000420)= 0.137334303517632E+02 gamma(00000420)= 0.137334303517632E+02 z1= 1 0.204334696045361E-06 0.000000000000000E+00 z1= 2 0.183815855400641E-03 0.000000000000000E+00 z1= 3 -0.495107398932292E-06 0.000000000000000E+00 Lanczos iteration: 421 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000421)= 0.000000000000000E+00 beta (00000421)= 0.125030268638402E+02 gamma(00000421)= 0.125030268638402E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 422 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000422)= 0.000000000000000E+00 beta (00000422)= 0.132628216399586E+02 gamma(00000422)= 0.132628216399586E+02 z1= 1 0.105454479497682E-07 0.000000000000000E+00 z1= 2 -0.186758187960979E-03 0.000000000000000E+00 z1= 3 0.499121047045376E-06 0.000000000000000E+00 Lanczos iteration: 423 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000423)= 0.000000000000000E+00 beta (00000423)= 0.127451656962747E+02 gamma(00000423)= 0.127451656962747E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 424 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000424)= 0.000000000000000E+00 beta (00000424)= 0.136565784207444E+02 gamma(00000424)= 0.136565784207444E+02 z1= 1 0.174062932399664E-06 0.000000000000000E+00 z1= 2 0.236565456177565E-03 0.000000000000000E+00 z1= 3 -0.529150784304294E-06 0.000000000000000E+00 Lanczos iteration: 425 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000425)= 0.000000000000000E+00 beta (00000425)= 0.128924421005736E+02 gamma(00000425)= 0.128924421005736E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 426 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000426)= 0.000000000000000E+00 beta (00000426)= 0.132324363263722E+02 gamma(00000426)= 0.132324363263722E+02 z1= 1 -0.243799507725030E-07 0.000000000000000E+00 z1= 2 -0.254348807215859E-03 0.000000000000000E+00 z1= 3 0.555308597620721E-06 0.000000000000000E+00 Lanczos iteration: 427 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000427)= 0.000000000000000E+00 beta (00000427)= 0.123640429588223E+02 gamma(00000427)= 0.123640429588223E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 428 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.1E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000428)= 0.000000000000000E+00 beta (00000428)= 0.134858210434650E+02 gamma(00000428)= 0.134858210434650E+02 z1= 1 0.141339734371980E-06 0.000000000000000E+00 z1= 2 0.289609278464061E-03 0.000000000000000E+00 z1= 3 -0.573119392314851E-06 0.000000000000000E+00 Lanczos iteration: 429 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000429)= 0.000000000000000E+00 beta (00000429)= 0.125052571635216E+02 gamma(00000429)= 0.125052571635216E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 430 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000430)= 0.000000000000000E+00 beta (00000430)= 0.134601558152466E+02 gamma(00000430)= 0.134601558152466E+02 z1= 1 -0.428604814343807E-07 0.000000000000000E+00 z1= 2 -0.304171400908792E-03 0.000000000000000E+00 z1= 3 0.582797370909591E-06 0.000000000000000E+00 Lanczos iteration: 431 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000431)= 0.000000000000000E+00 beta (00000431)= 0.124028792930433E+02 gamma(00000431)= 0.124028792930433E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 432 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.3E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000432)= 0.000000000000000E+00 beta (00000432)= 0.134521221779439E+02 gamma(00000432)= 0.134521221779439E+02 z1= 1 0.126523689290316E-06 0.000000000000000E+00 z1= 2 0.333883176552602E-03 0.000000000000000E+00 z1= 3 -0.605218445379717E-06 0.000000000000000E+00 Lanczos iteration: 433 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000433)= 0.000000000000000E+00 beta (00000433)= 0.123228796384228E+02 gamma(00000433)= 0.123228796384228E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 434 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.4E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000434)= 0.000000000000000E+00 beta (00000434)= 0.135156497334532E+02 gamma(00000434)= 0.135156497334532E+02 z1= 1 -0.472930404855215E-07 0.000000000000000E+00 z1= 2 -0.348614042146015E-03 0.000000000000000E+00 z1= 3 0.610229395898174E-06 0.000000000000000E+00 Lanczos iteration: 435 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000435)= 0.000000000000000E+00 beta (00000435)= 0.126063818596944E+02 gamma(00000435)= 0.126063818596944E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 436 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.4E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000436)= 0.000000000000000E+00 beta (00000436)= 0.134740182694126E+02 gamma(00000436)= 0.134740182694126E+02 z1= 1 0.125541753598704E-06 0.000000000000000E+00 z1= 2 0.376737304444543E-03 0.000000000000000E+00 z1= 3 -0.644696436367373E-06 0.000000000000000E+00 Lanczos iteration: 437 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000437)= 0.000000000000000E+00 beta (00000437)= 0.122763928840293E+02 gamma(00000437)= 0.122763928840293E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 438 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000438)= 0.000000000000000E+00 beta (00000438)= 0.131433008429165E+02 gamma(00000438)= 0.131433008429165E+02 z1= 1 -0.445521634562761E-07 0.000000000000000E+00 z1= 2 -0.403950906285097E-03 0.000000000000000E+00 z1= 3 0.667562485432295E-06 0.000000000000000E+00 Lanczos iteration: 439 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000439)= 0.000000000000000E+00 beta (00000439)= 0.126679269441363E+02 gamma(00000439)= 0.126679269441363E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 440 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000440)= 0.000000000000000E+00 beta (00000440)= 0.133309633716327E+02 gamma(00000440)= 0.133309633716327E+02 z1= 1 0.146965475237432E-06 0.000000000000000E+00 z1= 2 0.430476419001837E-03 0.000000000000000E+00 z1= 3 -0.715266704178798E-06 0.000000000000000E+00 Lanczos iteration: 441 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000441)= 0.000000000000000E+00 beta (00000441)= 0.127260898514123E+02 gamma(00000441)= 0.127260898514123E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 442 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000442)= 0.000000000000000E+00 beta (00000442)= 0.134980488335922E+02 gamma(00000442)= 0.134980488335922E+02 z1= 1 -0.275132569643732E-07 0.000000000000000E+00 z1= 2 -0.457635211703885E-03 0.000000000000000E+00 z1= 3 0.737954726572759E-06 0.000000000000000E+00 Lanczos iteration: 443 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000443)= 0.000000000000000E+00 beta (00000443)= 0.125396824756073E+02 gamma(00000443)= 0.125396824756073E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 444 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000444)= 0.000000000000000E+00 beta (00000444)= 0.135445054896804E+02 gamma(00000444)= 0.135445054896804E+02 z1= 1 0.177223317146535E-06 0.000000000000000E+00 z1= 2 0.463438357389658E-03 0.000000000000000E+00 z1= 3 -0.773059494222185E-06 0.000000000000000E+00 Lanczos iteration: 445 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000445)= 0.000000000000000E+00 beta (00000445)= 0.124286393179207E+02 gamma(00000445)= 0.124286393179207E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 446 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000446)= 0.000000000000000E+00 beta (00000446)= 0.136276148024266E+02 gamma(00000446)= 0.136276148024266E+02 z1= 1 0.116494422615354E-10 0.000000000000000E+00 z1= 2 -0.477564906964795E-03 0.000000000000000E+00 z1= 3 0.771392011839544E-06 0.000000000000000E+00 Lanczos iteration: 447 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000447)= 0.000000000000000E+00 beta (00000447)= 0.127521235377934E+02 gamma(00000447)= 0.127521235377934E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 448 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.7E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000448)= 0.000000000000000E+00 beta (00000448)= 0.132999947054912E+02 gamma(00000448)= 0.132999947054912E+02 z1= 1 0.216710923614180E-06 0.000000000000000E+00 z1= 2 0.493607143229439E-03 0.000000000000000E+00 z1= 3 -0.843746741122000E-06 0.000000000000000E+00 Lanczos iteration: 449 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000449)= 0.000000000000000E+00 beta (00000449)= 0.127990739181894E+02 gamma(00000449)= 0.127990739181894E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 450 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000450)= 0.000000000000000E+00 beta (00000450)= 0.134685662398796E+02 gamma(00000450)= 0.134685662398796E+02 z1= 1 0.200635965931506E-07 0.000000000000000E+00 z1= 2 -0.526935099782307E-03 0.000000000000000E+00 z1= 3 0.867000510443132E-06 0.000000000000000E+00 Lanczos iteration: 451 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000451)= 0.000000000000000E+00 beta (00000451)= 0.125848241638602E+02 gamma(00000451)= 0.125848241638602E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 452 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000452)= 0.000000000000000E+00 beta (00000452)= 0.133754947988012E+02 gamma(00000452)= 0.133754947988012E+02 z1= 1 0.261381887896404E-06 0.000000000000000E+00 z1= 2 0.525272338977947E-03 0.000000000000000E+00 z1= 3 -0.929269372706640E-06 0.000000000000000E+00 Lanczos iteration: 453 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000453)= 0.000000000000000E+00 beta (00000453)= 0.128099585306303E+02 gamma(00000453)= 0.128099585306303E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 454 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000454)= 0.000000000000000E+00 beta (00000454)= 0.136380856526670E+02 gamma(00000454)= 0.136380856526670E+02 z1= 1 0.504954196832788E-07 0.000000000000000E+00 z1= 2 -0.553550311595697E-03 0.000000000000000E+00 z1= 3 0.937019145792056E-06 0.000000000000000E+00 Lanczos iteration: 455 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000455)= 0.000000000000000E+00 beta (00000455)= 0.122753101915512E+02 gamma(00000455)= 0.122753101915512E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 456 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000456)= 0.000000000000000E+00 beta (00000456)= 0.136581110245951E+02 gamma(00000456)= 0.136581110245951E+02 z1= 1 0.304631040706251E-06 0.000000000000000E+00 z1= 2 0.522219980882959E-03 0.000000000000000E+00 z1= 3 -0.971153714973260E-06 0.000000000000000E+00 Lanczos iteration: 457 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000457)= 0.000000000000000E+00 beta (00000457)= 0.129393695420367E+02 gamma(00000457)= 0.129393695420367E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 458 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000458)= 0.000000000000000E+00 beta (00000458)= 0.134967006262180E+02 gamma(00000458)= 0.134967006262180E+02 z1= 1 0.809765188054465E-07 0.000000000000000E+00 z1= 2 -0.568281696440191E-03 0.000000000000000E+00 z1= 3 0.100060782143568E-05 0.000000000000000E+00 Lanczos iteration: 459 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000459)= 0.000000000000000E+00 beta (00000459)= 0.129527864954423E+02 gamma(00000459)= 0.129527864954423E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 460 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000460)= 0.000000000000000E+00 beta (00000460)= 0.137265479255010E+02 gamma(00000460)= 0.137265479255010E+02 z1= 1 0.312523258608893E-06 0.000000000000000E+00 z1= 2 0.558178646730866E-03 0.000000000000000E+00 z1= 3 -0.108043959846319E-05 0.000000000000000E+00 Lanczos iteration: 461 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000461)= 0.000000000000000E+00 beta (00000461)= 0.125991311647858E+02 gamma(00000461)= 0.125991311647858E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 462 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000462)= 0.000000000000000E+00 beta (00000462)= 0.133978855114032E+02 gamma(00000462)= 0.133978855114032E+02 z1= 1 0.414769023011734E-07 0.000000000000000E+00 z1= 2 -0.592732570084978E-03 0.000000000000000E+00 z1= 3 0.109690815089055E-05 0.000000000000000E+00 Lanczos iteration: 463 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000463)= 0.000000000000000E+00 beta (00000463)= 0.127240018730736E+02 gamma(00000463)= 0.127240018730736E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 464 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000464)= 0.000000000000000E+00 beta (00000464)= 0.133163581515820E+02 gamma(00000464)= 0.133163581515820E+02 z1= 1 0.283500497302684E-06 0.000000000000000E+00 z1= 2 0.595877397938895E-03 0.000000000000000E+00 z1= 3 -0.119074747452876E-05 0.000000000000000E+00 Lanczos iteration: 465 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000465)= 0.000000000000000E+00 beta (00000465)= 0.127268607255210E+02 gamma(00000465)= 0.127268607255210E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 466 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000466)= 0.000000000000000E+00 beta (00000466)= 0.134206923009464E+02 gamma(00000466)= 0.134206923009464E+02 z1= 1 0.623420725980040E-08 0.000000000000000E+00 z1= 2 -0.631527783626847E-03 0.000000000000000E+00 z1= 3 0.122026788195297E-05 0.000000000000000E+00 Lanczos iteration: 467 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000467)= 0.000000000000000E+00 beta (00000467)= 0.127666966626983E+02 gamma(00000467)= 0.127666966626983E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 468 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000468)= 0.000000000000000E+00 beta (00000468)= 0.135769526006323E+02 gamma(00000468)= 0.135769526006323E+02 z1= 1 0.262048549084029E-06 0.000000000000000E+00 z1= 2 0.626906135305756E-03 0.000000000000000E+00 z1= 3 -0.128920277224194E-05 0.000000000000000E+00 Lanczos iteration: 469 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000469)= 0.000000000000000E+00 beta (00000469)= 0.125445994205215E+02 gamma(00000469)= 0.125445994205215E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 470 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000470)= 0.000000000000000E+00 beta (00000470)= 0.136372563130480E+02 gamma(00000470)= 0.136372563130480E+02 z1= 1 -0.250984208086807E-07 0.000000000000000E+00 z1= 2 -0.643861825871523E-03 0.000000000000000E+00 z1= 3 0.129100143913070E-05 0.000000000000000E+00 Lanczos iteration: 471 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000471)= 0.000000000000000E+00 beta (00000471)= 0.129063767422562E+02 gamma(00000471)= 0.129063767422562E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 472 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.7E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000472)= 0.000000000000000E+00 beta (00000472)= 0.131649255383737E+02 gamma(00000472)= 0.131649255383737E+02 z1= 1 0.230755989596813E-06 0.000000000000000E+00 z1= 2 0.673525561701679E-03 0.000000000000000E+00 z1= 3 -0.141759149004149E-05 0.000000000000000E+00 Lanczos iteration: 473 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000473)= 0.000000000000000E+00 beta (00000473)= 0.127855514854716E+02 gamma(00000473)= 0.127855514854716E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 474 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000474)= 0.000000000000000E+00 beta (00000474)= 0.135794260816089E+02 gamma(00000474)= 0.135794260816089E+02 z1= 1 -0.713640746436220E-07 0.000000000000000E+00 z1= 2 -0.699043820004189E-03 0.000000000000000E+00 z1= 3 0.145060678962891E-05 0.000000000000000E+00 Lanczos iteration: 475 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000475)= 0.000000000000000E+00 beta (00000475)= 0.126246814036049E+02 gamma(00000475)= 0.126246814036049E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 476 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000476)= 0.000000000000000E+00 beta (00000476)= 0.130137246934313E+02 gamma(00000476)= 0.130137246934313E+02 z1= 1 0.198763645611888E-06 0.000000000000000E+00 z1= 2 0.728505311614218E-03 0.000000000000000E+00 z1= 3 -0.156081482187388E-05 0.000000000000000E+00 Lanczos iteration: 477 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000477)= 0.000000000000000E+00 beta (00000477)= 0.122939505993419E+02 gamma(00000477)= 0.122939505993419E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 478 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000478)= 0.000000000000000E+00 beta (00000478)= 0.135110557676942E+02 gamma(00000478)= 0.135110557676942E+02 z1= 1 -0.101516097967928E-06 0.000000000000000E+00 z1= 2 -0.728576669613262E-03 0.000000000000000E+00 z1= 3 0.155392338510932E-05 0.000000000000000E+00 Lanczos iteration: 479 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000479)= 0.000000000000000E+00 beta (00000479)= 0.128241493335414E+02 gamma(00000479)= 0.128241493335414E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 480 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000480)= 0.000000000000000E+00 beta (00000480)= 0.133213117575390E+02 gamma(00000480)= 0.133213117575390E+02 z1= 1 0.186070115396238E-06 0.000000000000000E+00 z1= 2 0.755411009175852E-03 0.000000000000000E+00 z1= 3 -0.165024650453723E-05 0.000000000000000E+00 Lanczos iteration: 481 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000481)= 0.000000000000000E+00 beta (00000481)= 0.130059743688142E+02 gamma(00000481)= 0.130059743688142E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 482 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000482)= 0.000000000000000E+00 beta (00000482)= 0.133053026138272E+02 gamma(00000482)= 0.133053026138272E+02 z1= 1 -0.130028983158417E-06 0.000000000000000E+00 z1= 2 -0.803544243575732E-03 0.000000000000000E+00 z1= 3 0.175452525181868E-05 0.000000000000000E+00 Lanczos iteration: 483 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000483)= 0.000000000000000E+00 beta (00000483)= 0.122316821939022E+02 gamma(00000483)= 0.122316821939022E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 484 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.4E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000484)= 0.000000000000000E+00 beta (00000484)= 0.131720821188095E+02 gamma(00000484)= 0.131720821188095E+02 z1= 1 0.177440871291373E-06 0.000000000000000E+00 z1= 2 0.806499898342621E-03 0.000000000000000E+00 z1= 3 -0.178950333431594E-05 0.000000000000000E+00 Lanczos iteration: 485 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000485)= 0.000000000000000E+00 beta (00000485)= 0.129964985736543E+02 gamma(00000485)= 0.129964985736543E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 486 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.9E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000486)= 0.000000000000000E+00 beta (00000486)= 0.131456428642896E+02 gamma(00000486)= 0.131456428642896E+02 z1= 1 -0.148393837893883E-06 0.000000000000000E+00 z1= 2 -0.863149190933991E-03 0.000000000000000E+00 z1= 3 0.192018015610735E-05 0.000000000000000E+00 Lanczos iteration: 487 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000487)= 0.000000000000000E+00 beta (00000487)= 0.125241630119097E+02 gamma(00000487)= 0.125241630119097E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 488 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.7E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000488)= 0.000000000000000E+00 beta (00000488)= 0.137264187800288E+02 gamma(00000488)= 0.137264187800288E+02 z1= 1 0.176152309860206E-06 0.000000000000000E+00 z1= 2 0.846458373418773E-03 0.000000000000000E+00 z1= 3 -0.190495710743459E-05 0.000000000000000E+00 Lanczos iteration: 489 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000489)= 0.000000000000000E+00 beta (00000489)= 0.130942181119134E+02 gamma(00000489)= 0.130942181119134E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 490 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000490)= 0.000000000000000E+00 beta (00000490)= 0.132925124350215E+02 gamma(00000490)= 0.132925124350215E+02 z1= 1 -0.161154426726873E-06 0.000000000000000E+00 z1= 2 -0.896959134751907E-03 0.000000000000000E+00 z1= 3 0.203416828787771E-05 0.000000000000000E+00 Lanczos iteration: 491 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000491)= 0.000000000000000E+00 beta (00000491)= 0.122825197938648E+02 gamma(00000491)= 0.122825197938648E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 492 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.7E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000492)= 0.000000000000000E+00 beta (00000492)= 0.133116971830317E+02 gamma(00000492)= 0.133116971830317E+02 z1= 1 0.174969563753857E-06 0.000000000000000E+00 z1= 2 0.891363071369465E-03 0.000000000000000E+00 z1= 3 -0.204597943156775E-05 0.000000000000000E+00 Lanczos iteration: 493 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000493)= 0.000000000000000E+00 beta (00000493)= 0.126685712731355E+02 gamma(00000493)= 0.126685712731355E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 494 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000494)= 0.000000000000000E+00 beta (00000494)= 0.134404278871689E+02 gamma(00000494)= 0.134404278871689E+02 z1= 1 -0.165239556379395E-06 0.000000000000000E+00 z1= 2 -0.901529113764680E-03 0.000000000000000E+00 z1= 3 0.209760689286512E-05 0.000000000000000E+00 Lanczos iteration: 495 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000495)= 0.000000000000000E+00 beta (00000495)= 0.120541980176322E+02 gamma(00000495)= 0.120541980176322E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 496 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000496)= 0.000000000000000E+00 beta (00000496)= 0.133056416644723E+02 gamma(00000496)= 0.133056416644723E+02 z1= 1 0.163087584358675E-06 0.000000000000000E+00 z1= 2 0.887277318889039E-03 0.000000000000000E+00 z1= 3 -0.208430538220787E-05 0.000000000000000E+00 Lanczos iteration: 497 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000497)= 0.000000000000000E+00 beta (00000497)= 0.123123669439439E+02 gamma(00000497)= 0.123123669439439E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 498 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000498)= 0.000000000000000E+00 beta (00000498)= 0.130332108867584E+02 gamma(00000498)= 0.130332108867584E+02 z1= 1 -0.166668116401841E-06 0.000000000000000E+00 z1= 2 -0.904471068256706E-03 0.000000000000000E+00 z1= 3 0.216510882241996E-05 0.000000000000000E+00 Lanczos iteration: 499 Pol:2 lr_apply_liouvillian: not applying interaction alpha(00000499)= 0.000000000000000E+00 beta (00000499)= 0.127058633387043E+02 gamma(00000499)= 0.127058633387043E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 500 Pol:2 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000500)= 0.000000000000000E+00 beta (00000500)= 0.128214081587216E+02 gamma(00000500)= 0.128214081587216E+02 z1= 1 0.170324919592825E-06 0.000000000000000E+00 z1= 2 0.976255811537579E-03 0.000000000000000E+00 z1= 3 -0.234236536790012E-05 0.000000000000000E+00 Reading d0psi Starting Lanczos loop 3 Lanczos iteration: 1 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000001)= 0.000000000000000E+00 beta (00000001)= 0.198589747430356E+01 gamma(00000001)= 0.198589747430356E+01 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 2 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.0E-13, # of iterations = 17 lr_apply_liouvillian: applying interaction: normal alpha(00000002)= 0.000000000000000E+00 beta (00000002)= 0.266005314869461E+01 gamma(00000002)= 0.266005314869461E+01 z1= 1 0.153149878085335E-07 0.000000000000000E+00 z1= 2 -0.963967110409643E-08 0.000000000000000E+00 z1= 3 0.746563080996377E+00 0.000000000000000E+00 Lanczos iteration: 3 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000003)= 0.000000000000000E+00 beta (00000003)= 0.941280302825463E+01 gamma(00000003)= 0.941280302825463E+01 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 4 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.7E-13, # of iterations = 18 lr_apply_liouvillian: applying interaction: normal alpha(00000004)= 0.000000000000000E+00 beta (00000004)= 0.143357323037776E+02 gamma(00000004)= 0.143357323037776E+02 z1= 1 -0.112645432885985E-07 0.000000000000000E+00 z1= 2 0.777255321974916E-08 0.000000000000000E+00 z1= 3 -0.490191298266226E+00 0.000000000000000E+00 Lanczos iteration: 5 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000005)= 0.000000000000000E+00 beta (00000005)= 0.121882281555263E+02 gamma(00000005)= 0.121882281555263E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 6 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.9E-13, # of iterations = 19 lr_apply_liouvillian: applying interaction: normal alpha(00000006)= 0.000000000000000E+00 beta (00000006)= 0.138954233120802E+02 gamma(00000006)= 0.138954233120802E+02 z1= 1 0.928393825721683E-08 0.000000000000000E+00 z1= 2 -0.808691025082353E-08 0.000000000000000E+00 z1= 3 0.429966118871175E+00 0.000000000000000E+00 Lanczos iteration: 7 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000007)= 0.000000000000000E+00 beta (00000007)= 0.124798888816113E+02 gamma(00000007)= 0.124798888816113E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 8 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 19 lr_apply_liouvillian: applying interaction: normal alpha(00000008)= 0.000000000000000E+00 beta (00000008)= 0.135517603889835E+02 gamma(00000008)= 0.135517603889835E+02 z1= 1 -0.897030872260181E-08 0.000000000000000E+00 z1= 2 0.881519883477733E-08 0.000000000000000E+00 z1= 3 -0.395959104347361E+00 0.000000000000000E+00 Lanczos iteration: 9 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000009)= 0.000000000000000E+00 beta (00000009)= 0.126276578696727E+02 gamma(00000009)= 0.126276578696727E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 10 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.3E-13, # of iterations = 18 lr_apply_liouvillian: applying interaction: normal alpha(00000010)= 0.000000000000000E+00 beta (00000010)= 0.134087301612166E+02 gamma(00000010)= 0.134087301612166E+02 z1= 1 0.101653780122776E-07 0.000000000000000E+00 z1= 2 -0.100301934438229E-07 0.000000000000000E+00 z1= 3 0.372893107049060E+00 0.000000000000000E+00 Lanczos iteration: 11 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000011)= 0.000000000000000E+00 beta (00000011)= 0.126837838776975E+02 gamma(00000011)= 0.126837838776975E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 12 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.4E-13, # of iterations = 18 lr_apply_liouvillian: applying interaction: normal alpha(00000012)= 0.000000000000000E+00 beta (00000012)= 0.133787991091204E+02 gamma(00000012)= 0.133787991091204E+02 z1= 1 -0.107843097667585E-07 0.000000000000000E+00 z1= 2 0.104746353470249E-07 0.000000000000000E+00 z1= 3 -0.353515777218546E+00 0.000000000000000E+00 Lanczos iteration: 13 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000013)= 0.000000000000000E+00 beta (00000013)= 0.126912090288545E+02 gamma(00000013)= 0.126912090288545E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 14 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.7E-13, # of iterations = 18 lr_apply_liouvillian: applying interaction: normal alpha(00000014)= 0.000000000000000E+00 beta (00000014)= 0.134095319906423E+02 gamma(00000014)= 0.134095319906423E+02 z1= 1 0.102082448255126E-07 0.000000000000000E+00 z1= 2 -0.958416204949533E-08 0.000000000000000E+00 z1= 3 0.334568311087617E+00 0.000000000000000E+00 Lanczos iteration: 15 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000015)= 0.000000000000000E+00 beta (00000015)= 0.127243819143487E+02 gamma(00000015)= 0.127243819143487E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 16 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.9E-13, # of iterations = 18 lr_apply_liouvillian: applying interaction: normal alpha(00000016)= 0.000000000000000E+00 beta (00000016)= 0.134837685420698E+02 gamma(00000016)= 0.134837685420698E+02 z1= 1 -0.864894342993486E-08 0.000000000000000E+00 z1= 2 0.822271392164967E-08 0.000000000000000E+00 z1= 3 -0.315713778492528E+00 0.000000000000000E+00 Lanczos iteration: 17 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000017)= 0.000000000000000E+00 beta (00000017)= 0.127724892422552E+02 gamma(00000017)= 0.127724892422552E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 18 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.0E-13, # of iterations = 18 lr_apply_liouvillian: applying interaction: normal alpha(00000018)= 0.000000000000000E+00 beta (00000018)= 0.134686888488423E+02 gamma(00000018)= 0.134686888488423E+02 z1= 1 0.709966456132784E-08 0.000000000000000E+00 z1= 2 -0.682889096073787E-08 0.000000000000000E+00 z1= 3 0.299381270918281E+00 0.000000000000000E+00 Lanczos iteration: 19 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000019)= 0.000000000000000E+00 beta (00000019)= 0.126919464046612E+02 gamma(00000019)= 0.126919464046612E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 20 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.1E-13, # of iterations = 18 lr_apply_liouvillian: applying interaction: normal alpha(00000020)= 0.000000000000000E+00 beta (00000020)= 0.133778291313841E+02 gamma(00000020)= 0.133778291313841E+02 z1= 1 -0.601461975753906E-08 0.000000000000000E+00 z1= 2 0.461247027074355E-08 0.000000000000000E+00 z1= 3 -0.284018200498036E+00 0.000000000000000E+00 Lanczos iteration: 21 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000021)= 0.000000000000000E+00 beta (00000021)= 0.127277651588611E+02 gamma(00000021)= 0.127277651588611E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 22 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.4E-13, # of iterations = 18 lr_apply_liouvillian: applying interaction: normal alpha(00000022)= 0.000000000000000E+00 beta (00000022)= 0.134706336392366E+02 gamma(00000022)= 0.134706336392366E+02 z1= 1 0.576641816013492E-08 0.000000000000000E+00 z1= 2 -0.157471428258171E-08 0.000000000000000E+00 z1= 3 0.268340606604539E+00 0.000000000000000E+00 Lanczos iteration: 23 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000023)= 0.000000000000000E+00 beta (00000023)= 0.127895838132924E+02 gamma(00000023)= 0.127895838132924E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 24 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.6E-13, # of iterations = 17 lr_apply_liouvillian: applying interaction: normal alpha(00000024)= 0.000000000000000E+00 beta (00000024)= 0.134414485414902E+02 gamma(00000024)= 0.134414485414902E+02 z1= 1 -0.641261342269016E-08 0.000000000000000E+00 z1= 2 -0.194560084102596E-08 0.000000000000000E+00 z1= 3 -0.255309834541439E+00 0.000000000000000E+00 Lanczos iteration: 25 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000025)= 0.000000000000000E+00 beta (00000025)= 0.128720203932412E+02 gamma(00000025)= 0.128720203932412E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 26 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.5E-13, # of iterations = 17 lr_apply_liouvillian: applying interaction: normal alpha(00000026)= 0.000000000000000E+00 beta (00000026)= 0.136147878518779E+02 gamma(00000026)= 0.136147878518779E+02 z1= 1 0.684726409372251E-08 0.000000000000000E+00 z1= 2 0.556724791224081E-08 0.000000000000000E+00 z1= 3 0.241360972955773E+00 0.000000000000000E+00 Lanczos iteration: 27 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000027)= 0.000000000000000E+00 beta (00000027)= 0.129098278716172E+02 gamma(00000027)= 0.129098278716172E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 28 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.5E-13, # of iterations = 17 lr_apply_liouvillian: applying interaction: normal alpha(00000028)= 0.000000000000000E+00 beta (00000028)= 0.134503382096599E+02 gamma(00000028)= 0.134503382096599E+02 z1= 1 -0.673738362257266E-08 0.000000000000000E+00 z1= 2 -0.794565043881618E-08 0.000000000000000E+00 z1= 3 -0.231636800330585E+00 0.000000000000000E+00 Lanczos iteration: 29 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000029)= 0.000000000000000E+00 beta (00000029)= 0.128064925548431E+02 gamma(00000029)= 0.128064925548431E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 30 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.5E-13, # of iterations = 17 lr_apply_liouvillian: applying interaction: normal alpha(00000030)= 0.000000000000000E+00 beta (00000030)= 0.134315407419753E+02 gamma(00000030)= 0.134315407419753E+02 z1= 1 0.648569814000466E-08 0.000000000000000E+00 z1= 2 0.892726049464207E-08 0.000000000000000E+00 z1= 3 0.220827356193647E+00 0.000000000000000E+00 Lanczos iteration: 31 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000031)= 0.000000000000000E+00 beta (00000031)= 0.127433344703282E+02 gamma(00000031)= 0.127433344703282E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 32 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.7E-13, # of iterations = 17 lr_apply_liouvillian: applying interaction: normal alpha(00000032)= 0.000000000000000E+00 beta (00000032)= 0.133606735815315E+02 gamma(00000032)= 0.133606735815315E+02 z1= 1 -0.585712236979459E-08 0.000000000000000E+00 z1= 2 -0.999206401864142E-08 0.000000000000000E+00 z1= 3 -0.210588173907276E+00 0.000000000000000E+00 Lanczos iteration: 33 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000033)= 0.000000000000000E+00 beta (00000033)= 0.126539853629806E+02 gamma(00000033)= 0.126539853629806E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 34 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.8E-13, # of iterations = 17 lr_apply_liouvillian: applying interaction: normal alpha(00000034)= 0.000000000000000E+00 beta (00000034)= 0.132882601980459E+02 gamma(00000034)= 0.132882601980459E+02 z1= 1 0.430886891867720E-08 0.000000000000000E+00 z1= 2 0.115610225876091E-07 0.000000000000000E+00 z1= 3 0.200494880252185E+00 0.000000000000000E+00 Lanczos iteration: 35 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000035)= 0.000000000000000E+00 beta (00000035)= 0.128109586273596E+02 gamma(00000035)= 0.128109586273596E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 36 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 17 lr_apply_liouvillian: applying interaction: normal alpha(00000036)= 0.000000000000000E+00 beta (00000036)= 0.133259692616610E+02 gamma(00000036)= 0.133259692616610E+02 z1= 1 -0.394279526031143E-08 0.000000000000000E+00 z1= 2 -0.135546818070924E-07 0.000000000000000E+00 z1= 3 -0.192700623024453E+00 0.000000000000000E+00 Lanczos iteration: 37 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000037)= 0.000000000000000E+00 beta (00000037)= 0.125858689451158E+02 gamma(00000037)= 0.125858689451158E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 38 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.2E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000038)= 0.000000000000000E+00 beta (00000038)= 0.135292406344040E+02 gamma(00000038)= 0.135292406344040E+02 z1= 1 0.501348867585835E-08 0.000000000000000E+00 z1= 2 0.156023716923678E-07 0.000000000000000E+00 z1= 3 0.179214151042323E+00 0.000000000000000E+00 Lanczos iteration: 39 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000039)= 0.000000000000000E+00 beta (00000039)= 0.129363589223143E+02 gamma(00000039)= 0.129363589223143E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 40 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.0E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000040)= 0.000000000000000E+00 beta (00000040)= 0.132944746476969E+02 gamma(00000040)= 0.132944746476969E+02 z1= 1 -0.640147967772252E-08 0.000000000000000E+00 z1= 2 -0.186285419147628E-07 0.000000000000000E+00 z1= 3 -0.174332734219191E+00 0.000000000000000E+00 Lanczos iteration: 41 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000041)= 0.000000000000000E+00 beta (00000041)= 0.126617354412438E+02 gamma(00000041)= 0.126617354412438E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 42 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.0E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000042)= 0.000000000000000E+00 beta (00000042)= 0.132829333739620E+02 gamma(00000042)= 0.132829333739620E+02 z1= 1 0.784682640999484E-08 0.000000000000000E+00 z1= 2 0.209628365764082E-07 0.000000000000000E+00 z1= 3 0.166123040382816E+00 0.000000000000000E+00 Lanczos iteration: 43 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000043)= 0.000000000000000E+00 beta (00000043)= 0.127919701534781E+02 gamma(00000043)= 0.127919701534781E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 44 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.3E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000044)= 0.000000000000000E+00 beta (00000044)= 0.134450788549700E+02 gamma(00000044)= 0.134450788549700E+02 z1= 1 -0.889896851000160E-08 0.000000000000000E+00 z1= 2 -0.230570599683323E-07 0.000000000000000E+00 z1= 3 -0.157996196948595E+00 0.000000000000000E+00 Lanczos iteration: 45 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000045)= 0.000000000000000E+00 beta (00000045)= 0.127158801830620E+02 gamma(00000045)= 0.127158801830620E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 46 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.6E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000046)= 0.000000000000000E+00 beta (00000046)= 0.133682100000167E+02 gamma(00000046)= 0.133682100000167E+02 z1= 1 0.937928648224624E-08 0.000000000000000E+00 z1= 2 0.249904629156215E-07 0.000000000000000E+00 z1= 3 0.150227465783706E+00 0.000000000000000E+00 Lanczos iteration: 47 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000047)= 0.000000000000000E+00 beta (00000047)= 0.126050507946093E+02 gamma(00000047)= 0.126050507946093E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 48 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.0E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000048)= 0.000000000000000E+00 beta (00000048)= 0.132920665406600E+02 gamma(00000048)= 0.132920665406600E+02 z1= 1 -0.960778568010780E-08 0.000000000000000E+00 z1= 2 -0.265637862067146E-07 0.000000000000000E+00 z1= 3 -0.142402542756756E+00 0.000000000000000E+00 Lanczos iteration: 49 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000049)= 0.000000000000000E+00 beta (00000049)= 0.126245790677907E+02 gamma(00000049)= 0.126245790677907E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 50 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.5E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000050)= 0.000000000000000E+00 beta (00000050)= 0.131105416200028E+02 gamma(00000050)= 0.131105416200028E+02 z1= 1 0.958841208590754E-08 0.000000000000000E+00 z1= 2 0.285230389533014E-07 0.000000000000000E+00 z1= 3 0.137063320694068E+00 0.000000000000000E+00 Lanczos iteration: 51 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000051)= 0.000000000000000E+00 beta (00000051)= 0.126514652365910E+02 gamma(00000051)= 0.126514652365910E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 52 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000052)= 0.000000000000000E+00 beta (00000052)= 0.131546957399052E+02 gamma(00000052)= 0.131546957399052E+02 z1= 1 -0.967951279393954E-08 0.000000000000000E+00 z1= 2 -0.303511903769482E-07 0.000000000000000E+00 z1= 3 -0.131761481590699E+00 0.000000000000000E+00 Lanczos iteration: 53 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000053)= 0.000000000000000E+00 beta (00000053)= 0.127236096305949E+02 gamma(00000053)= 0.127236096305949E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 54 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000054)= 0.000000000000000E+00 beta (00000054)= 0.132489689536034E+02 gamma(00000054)= 0.132489689536034E+02 z1= 1 0.106693286533151E-07 0.000000000000000E+00 z1= 2 0.318310102078584E-07 0.000000000000000E+00 z1= 3 0.126481246058676E+00 0.000000000000000E+00 Lanczos iteration: 55 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000055)= 0.000000000000000E+00 beta (00000055)= 0.126569516049073E+02 gamma(00000055)= 0.126569516049073E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 56 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000056)= 0.000000000000000E+00 beta (00000056)= 0.134572470915313E+02 gamma(00000056)= 0.134572470915313E+02 z1= 1 -0.120547402863861E-07 0.000000000000000E+00 z1= 2 -0.315092879184242E-07 0.000000000000000E+00 z1= 3 -0.118907470604609E+00 0.000000000000000E+00 Lanczos iteration: 57 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000057)= 0.000000000000000E+00 beta (00000057)= 0.127068701103825E+02 gamma(00000057)= 0.127068701103825E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 58 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000058)= 0.000000000000000E+00 beta (00000058)= 0.134315231066946E+02 gamma(00000058)= 0.134315231066946E+02 z1= 1 0.124360306483001E-07 0.000000000000000E+00 z1= 2 0.315653448657027E-07 0.000000000000000E+00 z1= 3 0.112441709708833E+00 0.000000000000000E+00 Lanczos iteration: 59 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000059)= 0.000000000000000E+00 beta (00000059)= 0.127673263546630E+02 gamma(00000059)= 0.127673263546630E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 60 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000060)= 0.000000000000000E+00 beta (00000060)= 0.132464517727084E+02 gamma(00000060)= 0.132464517727084E+02 z1= 1 -0.125928060131257E-07 0.000000000000000E+00 z1= 2 -0.328411918311053E-07 0.000000000000000E+00 z1= 3 -0.108326888481046E+00 0.000000000000000E+00 Lanczos iteration: 61 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000061)= 0.000000000000000E+00 beta (00000061)= 0.125205658894473E+02 gamma(00000061)= 0.125205658894473E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 62 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000062)= 0.000000000000000E+00 beta (00000062)= 0.133161528978489E+02 gamma(00000062)= 0.133161528978489E+02 z1= 1 0.130196873501538E-07 0.000000000000000E+00 z1= 2 0.335878007021867E-07 0.000000000000000E+00 z1= 3 0.101809166112172E+00 0.000000000000000E+00 Lanczos iteration: 63 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000063)= 0.000000000000000E+00 beta (00000063)= 0.125430135626687E+02 gamma(00000063)= 0.125430135626687E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 64 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.7E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000064)= 0.000000000000000E+00 beta (00000064)= 0.131850892232266E+02 gamma(00000064)= 0.131850892232266E+02 z1= 1 -0.133511054870115E-07 0.000000000000000E+00 z1= 2 -0.347213643201588E-07 0.000000000000000E+00 z1= 3 -0.968090677488378E-01 0.000000000000000E+00 Lanczos iteration: 65 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000065)= 0.000000000000000E+00 beta (00000065)= 0.126814829397719E+02 gamma(00000065)= 0.126814829397719E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 66 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000066)= 0.000000000000000E+00 beta (00000066)= 0.131033405640840E+02 gamma(00000066)= 0.131033405640840E+02 z1= 1 0.133441344851108E-07 0.000000000000000E+00 z1= 2 0.361976455606414E-07 0.000000000000000E+00 z1= 3 0.936522189927594E-01 0.000000000000000E+00 Lanczos iteration: 67 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000067)= 0.000000000000000E+00 beta (00000067)= 0.128533765959565E+02 gamma(00000067)= 0.128533765959565E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 68 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000068)= 0.000000000000000E+00 beta (00000068)= 0.132983820930220E+02 gamma(00000068)= 0.132983820930220E+02 z1= 1 -0.132786822110847E-07 0.000000000000000E+00 z1= 2 -0.375091343705544E-07 0.000000000000000E+00 z1= 3 -0.904845259278563E-01 0.000000000000000E+00 Lanczos iteration: 69 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000069)= 0.000000000000000E+00 beta (00000069)= 0.127670667196673E+02 gamma(00000069)= 0.127670667196673E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 70 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000070)= 0.000000000000000E+00 beta (00000070)= 0.130919734316332E+02 gamma(00000070)= 0.130919734316332E+02 z1= 1 0.143611114851189E-07 0.000000000000000E+00 z1= 2 0.386391948263565E-07 0.000000000000000E+00 z1= 3 0.882065804551055E-01 0.000000000000000E+00 Lanczos iteration: 71 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000071)= 0.000000000000000E+00 beta (00000071)= 0.127418973792079E+02 gamma(00000071)= 0.127418973792079E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 72 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000072)= 0.000000000000000E+00 beta (00000072)= 0.133775455160385E+02 gamma(00000072)= 0.133775455160385E+02 z1= 1 -0.152726788214905E-07 0.000000000000000E+00 z1= 2 -0.389444336900552E-07 0.000000000000000E+00 z1= 3 -0.839900657859174E-01 0.000000000000000E+00 Lanczos iteration: 73 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000073)= 0.000000000000000E+00 beta (00000073)= 0.126213847633479E+02 gamma(00000073)= 0.126213847633479E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 74 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000074)= 0.000000000000000E+00 beta (00000074)= 0.133181102665252E+02 gamma(00000074)= 0.133181102665252E+02 z1= 1 0.159116136809381E-07 0.000000000000000E+00 z1= 2 0.389584365852527E-07 0.000000000000000E+00 z1= 3 0.795706418998852E-01 0.000000000000000E+00 Lanczos iteration: 75 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000075)= 0.000000000000000E+00 beta (00000075)= 0.129522757961565E+02 gamma(00000075)= 0.129522757961565E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 76 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000076)= 0.000000000000000E+00 beta (00000076)= 0.136072432316721E+02 gamma(00000076)= 0.136072432316721E+02 z1= 1 -0.164130663864691E-07 0.000000000000000E+00 z1= 2 -0.394719576720173E-07 0.000000000000000E+00 z1= 3 -0.757223737967106E-01 0.000000000000000E+00 Lanczos iteration: 77 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000077)= 0.000000000000000E+00 beta (00000077)= 0.130542568643860E+02 gamma(00000077)= 0.130542568643860E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 78 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000078)= 0.000000000000000E+00 beta (00000078)= 0.134946677128768E+02 gamma(00000078)= 0.134946677128768E+02 z1= 1 0.174504517307626E-07 0.000000000000000E+00 z1= 2 0.412239049363619E-07 0.000000000000000E+00 z1= 3 0.732312343370757E-01 0.000000000000000E+00 Lanczos iteration: 79 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000079)= 0.000000000000000E+00 beta (00000079)= 0.128475308916870E+02 gamma(00000079)= 0.128475308916870E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 80 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000080)= 0.000000000000000E+00 beta (00000080)= 0.135769038416865E+02 gamma(00000080)= 0.135769038416865E+02 z1= 1 -0.186637619283003E-07 0.000000000000000E+00 z1= 2 -0.417672914639761E-07 0.000000000000000E+00 z1= 3 -0.692847119946537E-01 0.000000000000000E+00 Lanczos iteration: 81 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000081)= 0.000000000000000E+00 beta (00000081)= 0.127359344900197E+02 gamma(00000081)= 0.127359344900197E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 82 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000082)= 0.000000000000000E+00 beta (00000082)= 0.133647093515230E+02 gamma(00000082)= 0.133647093515230E+02 z1= 1 0.200373867647891E-07 0.000000000000000E+00 z1= 2 0.423874510673342E-07 0.000000000000000E+00 z1= 3 0.660108536242420E-01 0.000000000000000E+00 Lanczos iteration: 83 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000083)= 0.000000000000000E+00 beta (00000083)= 0.126879900778806E+02 gamma(00000083)= 0.126879900778806E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 84 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000084)= 0.000000000000000E+00 beta (00000084)= 0.135878678841031E+02 gamma(00000084)= 0.135878678841031E+02 z1= 1 -0.218212776684906E-07 0.000000000000000E+00 z1= 2 -0.422020916520174E-07 0.000000000000000E+00 z1= 3 -0.616317277715121E-01 0.000000000000000E+00 Lanczos iteration: 85 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000085)= 0.000000000000000E+00 beta (00000085)= 0.129027213883029E+02 gamma(00000085)= 0.129027213883029E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 86 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000086)= 0.000000000000000E+00 beta (00000086)= 0.134800225042985E+02 gamma(00000086)= 0.134800225042985E+02 z1= 1 0.247573159000390E-07 0.000000000000000E+00 z1= 2 0.432608453539152E-07 0.000000000000000E+00 z1= 3 0.589839827165716E-01 0.000000000000000E+00 Lanczos iteration: 87 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000087)= 0.000000000000000E+00 beta (00000087)= 0.125464483474963E+02 gamma(00000087)= 0.125464483474963E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 88 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000088)= 0.000000000000000E+00 beta (00000088)= 0.131711344375483E+02 gamma(00000088)= 0.131711344375483E+02 z1= 1 -0.272151164678160E-07 0.000000000000000E+00 z1= 2 -0.450449663550248E-07 0.000000000000000E+00 z1= 3 -0.561828220081659E-01 0.000000000000000E+00 Lanczos iteration: 89 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000089)= 0.000000000000000E+00 beta (00000089)= 0.127109046718902E+02 gamma(00000089)= 0.127109046718902E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 90 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000090)= 0.000000000000000E+00 beta (00000090)= 0.135664007805630E+02 gamma(00000090)= 0.135664007805630E+02 z1= 1 0.281835805720972E-07 0.000000000000000E+00 z1= 2 0.455821161041842E-07 0.000000000000000E+00 z1= 3 0.526361441784537E-01 0.000000000000000E+00 Lanczos iteration: 91 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000091)= 0.000000000000000E+00 beta (00000091)= 0.126763959702574E+02 gamma(00000091)= 0.126763959702574E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 92 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000092)= 0.000000000000000E+00 beta (00000092)= 0.131206266713886E+02 gamma(00000092)= 0.131206266713886E+02 z1= 1 -0.285850721024267E-07 0.000000000000000E+00 z1= 2 -0.476543324193918E-07 0.000000000000000E+00 z1= 3 -0.508534855592834E-01 0.000000000000000E+00 Lanczos iteration: 93 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000093)= 0.000000000000000E+00 beta (00000093)= 0.127417713680198E+02 gamma(00000093)= 0.127417713680198E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 94 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000094)= 0.000000000000000E+00 beta (00000094)= 0.131244092764117E+02 gamma(00000094)= 0.131244092764117E+02 z1= 1 0.287441954563514E-07 0.000000000000000E+00 z1= 2 0.508043113888954E-07 0.000000000000000E+00 z1= 3 0.493702669013081E-01 0.000000000000000E+00 Lanczos iteration: 95 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000095)= 0.000000000000000E+00 beta (00000095)= 0.126167548553091E+02 gamma(00000095)= 0.126167548553091E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 96 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000096)= 0.000000000000000E+00 beta (00000096)= 0.130501914969663E+02 gamma(00000096)= 0.130501914969663E+02 z1= 1 -0.288094452517186E-07 0.000000000000000E+00 z1= 2 -0.536659977958334E-07 0.000000000000000E+00 z1= 3 -0.477319208516072E-01 0.000000000000000E+00 Lanczos iteration: 97 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000097)= 0.000000000000000E+00 beta (00000097)= 0.129305760149469E+02 gamma(00000097)= 0.129305760149469E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 98 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000098)= 0.000000000000000E+00 beta (00000098)= 0.130694908230607E+02 gamma(00000098)= 0.130694908230607E+02 z1= 1 0.293152189756191E-07 0.000000000000000E+00 z1= 2 0.564041009506328E-07 0.000000000000000E+00 z1= 3 0.472258306378989E-01 0.000000000000000E+00 Lanczos iteration: 99 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000099)= 0.000000000000000E+00 beta (00000099)= 0.128250181693690E+02 gamma(00000099)= 0.128250181693690E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 100 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000100)= 0.000000000000000E+00 beta (00000100)= 0.132936067211191E+02 gamma(00000100)= 0.132936067211191E+02 z1= 1 -0.292343307309491E-07 0.000000000000000E+00 z1= 2 -0.568072460929020E-07 0.000000000000000E+00 z1= 3 -0.455631994213738E-01 0.000000000000000E+00 Lanczos iteration: 101 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000101)= 0.000000000000000E+00 beta (00000101)= 0.127825661590689E+02 gamma(00000101)= 0.127825661590689E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 102 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000102)= 0.000000000000000E+00 beta (00000102)= 0.129699867564368E+02 gamma(00000102)= 0.129699867564368E+02 z1= 1 0.288019898545249E-07 0.000000000000000E+00 z1= 2 0.580162109213231E-07 0.000000000000000E+00 z1= 3 0.449072979481342E-01 0.000000000000000E+00 Lanczos iteration: 103 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000103)= 0.000000000000000E+00 beta (00000103)= 0.126639010968224E+02 gamma(00000103)= 0.126639010968224E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 104 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000104)= 0.000000000000000E+00 beta (00000104)= 0.135222539129754E+02 gamma(00000104)= 0.135222539129754E+02 z1= 1 -0.275467936640492E-07 0.000000000000000E+00 z1= 2 -0.564982543674666E-07 0.000000000000000E+00 z1= 3 -0.420591181246939E-01 0.000000000000000E+00 Lanczos iteration: 105 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000105)= 0.000000000000000E+00 beta (00000105)= 0.129400864213033E+02 gamma(00000105)= 0.129400864213033E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 106 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000106)= 0.000000000000000E+00 beta (00000106)= 0.132777694071865E+02 gamma(00000106)= 0.132777694071865E+02 z1= 1 0.284663868681517E-07 0.000000000000000E+00 z1= 2 0.570494511830874E-07 0.000000000000000E+00 z1= 3 0.409929633879776E-01 0.000000000000000E+00 Lanczos iteration: 107 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000107)= 0.000000000000000E+00 beta (00000107)= 0.127551144396323E+02 gamma(00000107)= 0.127551144396323E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 108 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000108)= 0.000000000000000E+00 beta (00000108)= 0.134610335644070E+02 gamma(00000108)= 0.134610335644070E+02 z1= 1 -0.288570435702344E-07 0.000000000000000E+00 z1= 2 -0.555396560994285E-07 0.000000000000000E+00 z1= 3 -0.388464176872447E-01 0.000000000000000E+00 Lanczos iteration: 109 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000109)= 0.000000000000000E+00 beta (00000109)= 0.130004331608334E+02 gamma(00000109)= 0.130004331608334E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 110 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000110)= 0.000000000000000E+00 beta (00000110)= 0.134801537198253E+02 gamma(00000110)= 0.134801537198253E+02 z1= 1 0.301826524900682E-07 0.000000000000000E+00 z1= 2 0.556104628283982E-07 0.000000000000000E+00 z1= 3 0.374694505452065E-01 0.000000000000000E+00 Lanczos iteration: 111 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000111)= 0.000000000000000E+00 beta (00000111)= 0.126592410524364E+02 gamma(00000111)= 0.126592410524364E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 112 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000112)= 0.000000000000000E+00 beta (00000112)= 0.132260699727338E+02 gamma(00000112)= 0.132260699727338E+02 z1= 1 -0.309739983473463E-07 0.000000000000000E+00 z1= 2 -0.565901751561557E-07 0.000000000000000E+00 z1= 3 -0.358685759460047E-01 0.000000000000000E+00 Lanczos iteration: 113 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000113)= 0.000000000000000E+00 beta (00000113)= 0.125787390078361E+02 gamma(00000113)= 0.125787390078361E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 114 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000114)= 0.000000000000000E+00 beta (00000114)= 0.130416123502651E+02 gamma(00000114)= 0.130416123502651E+02 z1= 1 0.317485467905788E-07 0.000000000000000E+00 z1= 2 0.580123196850316E-07 0.000000000000000E+00 z1= 3 0.346034927209365E-01 0.000000000000000E+00 Lanczos iteration: 115 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000115)= 0.000000000000000E+00 beta (00000115)= 0.124651368703441E+02 gamma(00000115)= 0.124651368703441E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 116 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000116)= 0.000000000000000E+00 beta (00000116)= 0.133127282718330E+02 gamma(00000116)= 0.133127282718330E+02 z1= 1 -0.319566540088858E-07 0.000000000000000E+00 z1= 2 -0.577897369307204E-07 0.000000000000000E+00 z1= 3 -0.324061018266119E-01 0.000000000000000E+00 Lanczos iteration: 117 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000117)= 0.000000000000000E+00 beta (00000117)= 0.129165527828398E+02 gamma(00000117)= 0.129165527828398E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 118 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000118)= 0.000000000000000E+00 beta (00000118)= 0.133529956879481E+02 gamma(00000118)= 0.133529956879481E+02 z1= 1 0.334264493209290E-07 0.000000000000000E+00 z1= 2 0.594440002911305E-07 0.000000000000000E+00 z1= 3 0.313559903577044E-01 0.000000000000000E+00 Lanczos iteration: 119 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000119)= 0.000000000000000E+00 beta (00000119)= 0.129231219213037E+02 gamma(00000119)= 0.129231219213037E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 120 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000120)= 0.000000000000000E+00 beta (00000120)= 0.133421820014633E+02 gamma(00000120)= 0.133421820014633E+02 z1= 1 -0.355477554536340E-07 0.000000000000000E+00 z1= 2 -0.601800950171018E-07 0.000000000000000E+00 z1= 3 -0.303761139755308E-01 0.000000000000000E+00 Lanczos iteration: 121 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000121)= 0.000000000000000E+00 beta (00000121)= 0.130723324905065E+02 gamma(00000121)= 0.130723324905065E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 122 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000122)= 0.000000000000000E+00 beta (00000122)= 0.138308545135177E+02 gamma(00000122)= 0.138308545135177E+02 z1= 1 0.356717340018733E-07 0.000000000000000E+00 z1= 2 0.591538244472736E-07 0.000000000000000E+00 z1= 3 0.287200475310270E-01 0.000000000000000E+00 Lanczos iteration: 123 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000123)= 0.000000000000000E+00 beta (00000123)= 0.126092695179497E+02 gamma(00000123)= 0.126092695179497E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 124 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000124)= 0.000000000000000E+00 beta (00000124)= 0.133723372808900E+02 gamma(00000124)= 0.133723372808900E+02 z1= 1 -0.348162011755957E-07 0.000000000000000E+00 z1= 2 -0.582678440130737E-07 0.000000000000000E+00 z1= 3 -0.270863522451070E-01 0.000000000000000E+00 Lanczos iteration: 125 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000125)= 0.000000000000000E+00 beta (00000125)= 0.129909442989212E+02 gamma(00000125)= 0.129909442989212E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 126 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000126)= 0.000000000000000E+00 beta (00000126)= 0.136629604395867E+02 gamma(00000126)= 0.136629604395867E+02 z1= 1 0.340453179433473E-07 0.000000000000000E+00 z1= 2 0.583694405352844E-07 0.000000000000000E+00 z1= 3 0.257640221692935E-01 0.000000000000000E+00 Lanczos iteration: 127 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000127)= 0.000000000000000E+00 beta (00000127)= 0.125949639001506E+02 gamma(00000127)= 0.125949639001506E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 128 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.7E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000128)= 0.000000000000000E+00 beta (00000128)= 0.132210266850789E+02 gamma(00000128)= 0.132210266850789E+02 z1= 1 -0.331635540344426E-07 0.000000000000000E+00 z1= 2 -0.589661785528996E-07 0.000000000000000E+00 z1= 3 -0.245495331963424E-01 0.000000000000000E+00 Lanczos iteration: 129 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000129)= 0.000000000000000E+00 beta (00000129)= 0.126762577548889E+02 gamma(00000129)= 0.126762577548889E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 130 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000130)= 0.000000000000000E+00 beta (00000130)= 0.134394379138877E+02 gamma(00000130)= 0.134394379138877E+02 z1= 1 0.323621046178992E-07 0.000000000000000E+00 z1= 2 0.588144327365206E-07 0.000000000000000E+00 z1= 3 0.231648790198515E-01 0.000000000000000E+00 Lanczos iteration: 131 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000131)= 0.000000000000000E+00 beta (00000131)= 0.129683536248709E+02 gamma(00000131)= 0.129683536248709E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 132 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000132)= 0.000000000000000E+00 beta (00000132)= 0.133084857034860E+02 gamma(00000132)= 0.133084857034860E+02 z1= 1 -0.323297190197355E-07 0.000000000000000E+00 z1= 2 -0.603718513555573E-07 0.000000000000000E+00 z1= 3 -0.225784555703052E-01 0.000000000000000E+00 Lanczos iteration: 133 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000133)= 0.000000000000000E+00 beta (00000133)= 0.126237242094715E+02 gamma(00000133)= 0.126237242094715E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 134 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000134)= 0.000000000000000E+00 beta (00000134)= 0.133179043585291E+02 gamma(00000134)= 0.133179043585291E+02 z1= 1 0.311596518705543E-07 0.000000000000000E+00 z1= 2 0.605370446034727E-07 0.000000000000000E+00 z1= 3 0.214106887331424E-01 0.000000000000000E+00 Lanczos iteration: 135 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000135)= 0.000000000000000E+00 beta (00000135)= 0.126289534270244E+02 gamma(00000135)= 0.126289534270244E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 136 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000136)= 0.000000000000000E+00 beta (00000136)= 0.134393139397769E+02 gamma(00000136)= 0.134393139397769E+02 z1= 1 -0.308531752734155E-07 0.000000000000000E+00 z1= 2 -0.607399456518118E-07 0.000000000000000E+00 z1= 3 -0.201264184782455E-01 0.000000000000000E+00 Lanczos iteration: 137 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000137)= 0.000000000000000E+00 beta (00000137)= 0.129299249305186E+02 gamma(00000137)= 0.129299249305186E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 138 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000138)= 0.000000000000000E+00 beta (00000138)= 0.132395566093757E+02 gamma(00000138)= 0.132395566093757E+02 z1= 1 0.319435245595351E-07 0.000000000000000E+00 z1= 2 0.634872925545766E-07 0.000000000000000E+00 z1= 3 0.196649264747336E-01 0.000000000000000E+00 Lanczos iteration: 139 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000139)= 0.000000000000000E+00 beta (00000139)= 0.128022756762736E+02 gamma(00000139)= 0.128022756762736E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 140 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000140)= 0.000000000000000E+00 beta (00000140)= 0.135041972592583E+02 gamma(00000140)= 0.135041972592583E+02 z1= 1 -0.317800520154400E-07 0.000000000000000E+00 z1= 2 -0.635007906450800E-07 0.000000000000000E+00 z1= 3 -0.186502687004363E-01 0.000000000000000E+00 Lanczos iteration: 141 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000141)= 0.000000000000000E+00 beta (00000141)= 0.123992234659556E+02 gamma(00000141)= 0.123992234659556E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 142 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.7E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000142)= 0.000000000000000E+00 beta (00000142)= 0.132323119524857E+02 gamma(00000142)= 0.132323119524857E+02 z1= 1 0.322419802060167E-07 0.000000000000000E+00 z1= 2 0.619700309063332E-07 0.000000000000000E+00 z1= 3 0.174859373427838E-01 0.000000000000000E+00 Lanczos iteration: 143 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000143)= 0.000000000000000E+00 beta (00000143)= 0.127233598950286E+02 gamma(00000143)= 0.127233598950286E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 144 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000144)= 0.000000000000000E+00 beta (00000144)= 0.133308986030832E+02 gamma(00000144)= 0.133308986030832E+02 z1= 1 -0.336911936587095E-07 0.000000000000000E+00 z1= 2 -0.607624286449266E-07 0.000000000000000E+00 z1= 3 -0.166983969126179E-01 0.000000000000000E+00 Lanczos iteration: 145 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000145)= 0.000000000000000E+00 beta (00000145)= 0.125952680142789E+02 gamma(00000145)= 0.125952680142789E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 146 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000146)= 0.000000000000000E+00 beta (00000146)= 0.131254484942068E+02 gamma(00000146)= 0.131254484942068E+02 z1= 1 0.349230949807638E-07 0.000000000000000E+00 z1= 2 0.604400321241782E-07 0.000000000000000E+00 z1= 3 0.160342584484542E-01 0.000000000000000E+00 Lanczos iteration: 147 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000147)= 0.000000000000000E+00 beta (00000147)= 0.122693100486419E+02 gamma(00000147)= 0.122693100486419E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 148 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.7E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000148)= 0.000000000000000E+00 beta (00000148)= 0.136721762155089E+02 gamma(00000148)= 0.136721762155089E+02 z1= 1 -0.337363701530908E-07 0.000000000000000E+00 z1= 2 -0.567041480168052E-07 0.000000000000000E+00 z1= 3 -0.143988256757431E-01 0.000000000000000E+00 Lanczos iteration: 149 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000149)= 0.000000000000000E+00 beta (00000149)= 0.127424813255371E+02 gamma(00000149)= 0.127424813255371E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 150 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000150)= 0.000000000000000E+00 beta (00000150)= 0.128120978501888E+02 gamma(00000150)= 0.128120978501888E+02 z1= 1 0.359445116840428E-07 0.000000000000000E+00 z1= 2 0.591411435301662E-07 0.000000000000000E+00 z1= 3 0.143315480868956E-01 0.000000000000000E+00 Lanczos iteration: 151 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000151)= 0.000000000000000E+00 beta (00000151)= 0.129240436021754E+02 gamma(00000151)= 0.129240436021754E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 152 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000152)= 0.000000000000000E+00 beta (00000152)= 0.135196767812544E+02 gamma(00000152)= 0.135196767812544E+02 z1= 1 -0.359451469199388E-07 0.000000000000000E+00 z1= 2 -0.601007820670140E-07 0.000000000000000E+00 z1= 3 -0.137100048387024E-01 0.000000000000000E+00 Lanczos iteration: 153 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000153)= 0.000000000000000E+00 beta (00000153)= 0.124271531616797E+02 gamma(00000153)= 0.124271531616797E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 154 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000154)= 0.000000000000000E+00 beta (00000154)= 0.132349514023258E+02 gamma(00000154)= 0.132349514023258E+02 z1= 1 0.349324410027670E-07 0.000000000000000E+00 z1= 2 0.601946924592804E-07 0.000000000000000E+00 z1= 3 0.128833294294418E-01 0.000000000000000E+00 Lanczos iteration: 155 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000155)= 0.000000000000000E+00 beta (00000155)= 0.126019371473048E+02 gamma(00000155)= 0.126019371473048E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 156 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000156)= 0.000000000000000E+00 beta (00000156)= 0.131294133449266E+02 gamma(00000156)= 0.131294133449266E+02 z1= 1 -0.355524618106829E-07 0.000000000000000E+00 z1= 2 -0.610538641622471E-07 0.000000000000000E+00 z1= 3 -0.123769295157160E-01 0.000000000000000E+00 Lanczos iteration: 157 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000157)= 0.000000000000000E+00 beta (00000157)= 0.125730252596794E+02 gamma(00000157)= 0.125730252596794E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 158 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000158)= 0.000000000000000E+00 beta (00000158)= 0.130732523865245E+02 gamma(00000158)= 0.130732523865245E+02 z1= 1 0.365518551373770E-07 0.000000000000000E+00 z1= 2 0.614632257567825E-07 0.000000000000000E+00 z1= 3 0.119138353498951E-01 0.000000000000000E+00 Lanczos iteration: 159 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000159)= 0.000000000000000E+00 beta (00000159)= 0.128978807596304E+02 gamma(00000159)= 0.128978807596304E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 160 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000160)= 0.000000000000000E+00 beta (00000160)= 0.129100134355946E+02 gamma(00000160)= 0.129100134355946E+02 z1= 1 -0.380005155996093E-07 0.000000000000000E+00 z1= 2 -0.632109748007967E-07 0.000000000000000E+00 z1= 3 -0.119150346144856E-01 0.000000000000000E+00 Lanczos iteration: 161 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000161)= 0.000000000000000E+00 beta (00000161)= 0.127630309785070E+02 gamma(00000161)= 0.127630309785070E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 162 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000162)= 0.000000000000000E+00 beta (00000162)= 0.131500195275217E+02 gamma(00000162)= 0.131500195275217E+02 z1= 1 0.380104328745641E-07 0.000000000000000E+00 z1= 2 0.636980271328559E-07 0.000000000000000E+00 z1= 3 0.115738180110122E-01 0.000000000000000E+00 Lanczos iteration: 163 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000163)= 0.000000000000000E+00 beta (00000163)= 0.128823675942065E+02 gamma(00000163)= 0.128823675942065E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 164 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000164)= 0.000000000000000E+00 beta (00000164)= 0.134169519400970E+02 gamma(00000164)= 0.134169519400970E+02 z1= 1 -0.374933583432600E-07 0.000000000000000E+00 z1= 2 -0.642170110639901E-07 0.000000000000000E+00 z1= 3 -0.111254907589817E-01 0.000000000000000E+00 Lanczos iteration: 165 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000165)= 0.000000000000000E+00 beta (00000165)= 0.124885802066872E+02 gamma(00000165)= 0.124885802066872E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 166 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000166)= 0.000000000000000E+00 beta (00000166)= 0.134111511267589E+02 gamma(00000166)= 0.134111511267589E+02 z1= 1 0.356423578674273E-07 0.000000000000000E+00 z1= 2 0.619379457494820E-07 0.000000000000000E+00 z1= 3 0.103688335972614E-01 0.000000000000000E+00 Lanczos iteration: 167 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000167)= 0.000000000000000E+00 beta (00000167)= 0.125627947544227E+02 gamma(00000167)= 0.125627947544227E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 168 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000168)= 0.000000000000000E+00 beta (00000168)= 0.132703894811758E+02 gamma(00000168)= 0.132703894811758E+02 z1= 1 -0.347185715771255E-07 0.000000000000000E+00 z1= 2 -0.592640791985660E-07 0.000000000000000E+00 z1= 3 -0.983026435591662E-02 0.000000000000000E+00 Lanczos iteration: 169 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000169)= 0.000000000000000E+00 beta (00000169)= 0.128533695825807E+02 gamma(00000169)= 0.128533695825807E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 170 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000170)= 0.000000000000000E+00 beta (00000170)= 0.137433426329697E+02 gamma(00000170)= 0.137433426329697E+02 z1= 1 0.350049394644281E-07 0.000000000000000E+00 z1= 2 0.554416600727706E-07 0.000000000000000E+00 z1= 3 0.919996427761395E-02 0.000000000000000E+00 Lanczos iteration: 171 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000171)= 0.000000000000000E+00 beta (00000171)= 0.125742301129617E+02 gamma(00000171)= 0.125742301129617E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 172 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.7E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000172)= 0.000000000000000E+00 beta (00000172)= 0.132348476159350E+02 gamma(00000172)= 0.132348476159350E+02 z1= 1 -0.369318001890075E-07 0.000000000000000E+00 z1= 2 -0.544591219123463E-07 0.000000000000000E+00 z1= 3 -0.875601396065007E-02 0.000000000000000E+00 Lanczos iteration: 173 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000173)= 0.000000000000000E+00 beta (00000173)= 0.129770036134974E+02 gamma(00000173)= 0.129770036134974E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 174 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000174)= 0.000000000000000E+00 beta (00000174)= 0.132145121150573E+02 gamma(00000174)= 0.132145121150573E+02 z1= 1 0.404208309423386E-07 0.000000000000000E+00 z1= 2 0.555839286751599E-07 0.000000000000000E+00 z1= 3 0.860271563694267E-02 0.000000000000000E+00 Lanczos iteration: 175 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000175)= 0.000000000000000E+00 beta (00000175)= 0.129294018798106E+02 gamma(00000175)= 0.129294018798106E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 176 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000176)= 0.000000000000000E+00 beta (00000176)= 0.133047862132562E+02 gamma(00000176)= 0.133047862132562E+02 z1= 1 -0.434229216615852E-07 0.000000000000000E+00 z1= 2 -0.575127984275576E-07 0.000000000000000E+00 z1= 3 -0.837380455480890E-02 0.000000000000000E+00 Lanczos iteration: 177 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000177)= 0.000000000000000E+00 beta (00000177)= 0.127261302986333E+02 gamma(00000177)= 0.127261302986333E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 178 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000178)= 0.000000000000000E+00 beta (00000178)= 0.129213690737366E+02 gamma(00000178)= 0.129213690737366E+02 z1= 1 0.470525137637179E-07 0.000000000000000E+00 z1= 2 0.592112224336483E-07 0.000000000000000E+00 z1= 3 0.824720887104428E-02 0.000000000000000E+00 Lanczos iteration: 179 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000179)= 0.000000000000000E+00 beta (00000179)= 0.130863736356572E+02 gamma(00000179)= 0.130863736356572E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 180 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000180)= 0.000000000000000E+00 beta (00000180)= 0.132719990395493E+02 gamma(00000180)= 0.132719990395493E+02 z1= 1 -0.489090949938337E-07 0.000000000000000E+00 z1= 2 -0.607337258401995E-07 0.000000000000000E+00 z1= 3 -0.814435940692819E-02 0.000000000000000E+00 Lanczos iteration: 181 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000181)= 0.000000000000000E+00 beta (00000181)= 0.129054070122608E+02 gamma(00000181)= 0.129054070122608E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 182 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000182)= 0.000000000000000E+00 beta (00000182)= 0.134702971075094E+02 gamma(00000182)= 0.134702971075094E+02 z1= 1 0.494120556628237E-07 0.000000000000000E+00 z1= 2 0.603097807123898E-07 0.000000000000000E+00 z1= 3 0.779700684476806E-02 0.000000000000000E+00 Lanczos iteration: 183 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000183)= 0.000000000000000E+00 beta (00000183)= 0.127831717990293E+02 gamma(00000183)= 0.127831717990293E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 184 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000184)= 0.000000000000000E+00 beta (00000184)= 0.134151159911888E+02 gamma(00000184)= 0.134151159911888E+02 z1= 1 -0.489479302341958E-07 0.000000000000000E+00 z1= 2 -0.613157775095942E-07 0.000000000000000E+00 z1= 3 -0.744050632350950E-02 0.000000000000000E+00 Lanczos iteration: 185 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000185)= 0.000000000000000E+00 beta (00000185)= 0.133786009289794E+02 gamma(00000185)= 0.133786009289794E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 186 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000186)= 0.000000000000000E+00 beta (00000186)= 0.130149017089420E+02 gamma(00000186)= 0.130149017089420E+02 z1= 1 0.526790111736279E-07 0.000000000000000E+00 z1= 2 0.663069391647949E-07 0.000000000000000E+00 z1= 3 0.763924454889554E-02 0.000000000000000E+00 Lanczos iteration: 187 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000187)= 0.000000000000000E+00 beta (00000187)= 0.128147420207068E+02 gamma(00000187)= 0.128147420207068E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 188 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000188)= 0.000000000000000E+00 beta (00000188)= 0.133730062129784E+02 gamma(00000188)= 0.133730062129784E+02 z1= 1 -0.514388229623866E-07 0.000000000000000E+00 z1= 2 -0.668818394330278E-07 0.000000000000000E+00 z1= 3 -0.732825011052575E-02 0.000000000000000E+00 Lanczos iteration: 189 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000189)= 0.000000000000000E+00 beta (00000189)= 0.125372271621586E+02 gamma(00000189)= 0.125372271621586E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 190 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000190)= 0.000000000000000E+00 beta (00000190)= 0.134861773797153E+02 gamma(00000190)= 0.134861773797153E+02 z1= 1 0.491956189849988E-07 0.000000000000000E+00 z1= 2 0.647539927535728E-07 0.000000000000000E+00 z1= 3 0.680215913858932E-02 0.000000000000000E+00 Lanczos iteration: 191 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000191)= 0.000000000000000E+00 beta (00000191)= 0.129531701187784E+02 gamma(00000191)= 0.129531701187784E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 192 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000192)= 0.000000000000000E+00 beta (00000192)= 0.131339320800360E+02 gamma(00000192)= 0.131339320800360E+02 z1= 1 -0.502166111898423E-07 0.000000000000000E+00 z1= 2 -0.672722620712572E-07 0.000000000000000E+00 z1= 3 -0.671420002573710E-02 0.000000000000000E+00 Lanczos iteration: 193 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000193)= 0.000000000000000E+00 beta (00000193)= 0.132315037713875E+02 gamma(00000193)= 0.132315037713875E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 194 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000194)= 0.000000000000000E+00 beta (00000194)= 0.135653493124664E+02 gamma(00000194)= 0.135653493124664E+02 z1= 1 0.515054976294761E-07 0.000000000000000E+00 z1= 2 0.680228637816010E-07 0.000000000000000E+00 z1= 3 0.653807036480736E-02 0.000000000000000E+00 Lanczos iteration: 195 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000195)= 0.000000000000000E+00 beta (00000195)= 0.127110363243829E+02 gamma(00000195)= 0.127110363243829E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 196 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000196)= 0.000000000000000E+00 beta (00000196)= 0.139186260169762E+02 gamma(00000196)= 0.139186260169762E+02 z1= 1 -0.488581049749859E-07 0.000000000000000E+00 z1= 2 -0.650847665633909E-07 0.000000000000000E+00 z1= 3 -0.597448640452065E-02 0.000000000000000E+00 Lanczos iteration: 197 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000197)= 0.000000000000000E+00 beta (00000197)= 0.119716687599010E+02 gamma(00000197)= 0.119716687599010E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 198 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.6E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000198)= 0.000000000000000E+00 beta (00000198)= 0.138615984255510E+02 gamma(00000198)= 0.138615984255510E+02 z1= 1 0.452741528377508E-07 0.000000000000000E+00 z1= 2 0.599978656861929E-07 0.000000000000000E+00 z1= 3 0.515200033444303E-02 0.000000000000000E+00 Lanczos iteration: 199 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000199)= 0.000000000000000E+00 beta (00000199)= 0.122226512647498E+02 gamma(00000199)= 0.122226512647498E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 200 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.8E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000200)= 0.000000000000000E+00 beta (00000200)= 0.135898904690096E+02 gamma(00000200)= 0.135898904690096E+02 z1= 1 -0.436681085798796E-07 0.000000000000000E+00 z1= 2 -0.580924510204094E-07 0.000000000000000E+00 z1= 3 -0.463448672946174E-02 0.000000000000000E+00 Lanczos iteration: 201 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000201)= 0.000000000000000E+00 beta (00000201)= 0.124827065947230E+02 gamma(00000201)= 0.124827065947230E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 202 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.5E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000202)= 0.000000000000000E+00 beta (00000202)= 0.131802664915136E+02 gamma(00000202)= 0.131802664915136E+02 z1= 1 0.448612118937250E-07 0.000000000000000E+00 z1= 2 0.579309512966047E-07 0.000000000000000E+00 z1= 3 0.438308496981814E-02 0.000000000000000E+00 Lanczos iteration: 203 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000203)= 0.000000000000000E+00 beta (00000203)= 0.128773148598853E+02 gamma(00000203)= 0.128773148598853E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 204 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000204)= 0.000000000000000E+00 beta (00000204)= 0.131000769395632E+02 gamma(00000204)= 0.131000769395632E+02 z1= 1 -0.465674279694853E-07 0.000000000000000E+00 z1= 2 -0.599088952280761E-07 0.000000000000000E+00 z1= 3 -0.430841480160919E-02 0.000000000000000E+00 Lanczos iteration: 205 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000205)= 0.000000000000000E+00 beta (00000205)= 0.125951235848252E+02 gamma(00000205)= 0.125951235848252E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 206 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000206)= 0.000000000000000E+00 beta (00000206)= 0.130223114379423E+02 gamma(00000206)= 0.130223114379423E+02 z1= 1 0.466034910972298E-07 0.000000000000000E+00 z1= 2 0.604800478521328E-07 0.000000000000000E+00 z1= 3 0.416471371280305E-02 0.000000000000000E+00 Lanczos iteration: 207 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000207)= 0.000000000000000E+00 beta (00000207)= 0.127204270802809E+02 gamma(00000207)= 0.127204270802809E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 208 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000208)= 0.000000000000000E+00 beta (00000208)= 0.132745426822316E+02 gamma(00000208)= 0.132745426822316E+02 z1= 1 -0.460324787952262E-07 0.000000000000000E+00 z1= 2 -0.608225353251933E-07 0.000000000000000E+00 z1= 3 -0.399242207159844E-02 0.000000000000000E+00 Lanczos iteration: 209 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000209)= 0.000000000000000E+00 beta (00000209)= 0.123805943528707E+02 gamma(00000209)= 0.123805943528707E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 210 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000210)= 0.000000000000000E+00 beta (00000210)= 0.129190506295104E+02 gamma(00000210)= 0.129190506295104E+02 z1= 1 0.462158740315065E-07 0.000000000000000E+00 z1= 2 0.616227833006092E-07 0.000000000000000E+00 z1= 3 0.382713802381546E-02 0.000000000000000E+00 Lanczos iteration: 211 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000211)= 0.000000000000000E+00 beta (00000211)= 0.126808011310463E+02 gamma(00000211)= 0.126808011310463E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 212 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000212)= 0.000000000000000E+00 beta (00000212)= 0.133848266462087E+02 gamma(00000212)= 0.133848266462087E+02 z1= 1 -0.456036923630844E-07 0.000000000000000E+00 z1= 2 -0.624120024160166E-07 0.000000000000000E+00 z1= 3 -0.362941325483973E-02 0.000000000000000E+00 Lanczos iteration: 213 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000213)= 0.000000000000000E+00 beta (00000213)= 0.124456283362385E+02 gamma(00000213)= 0.124456283362385E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 214 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000214)= 0.000000000000000E+00 beta (00000214)= 0.131277607924832E+02 gamma(00000214)= 0.131277607924832E+02 z1= 1 0.450434787534247E-07 0.000000000000000E+00 z1= 2 0.631433279476169E-07 0.000000000000000E+00 z1= 3 0.344426286116683E-02 0.000000000000000E+00 Lanczos iteration: 215 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000215)= 0.000000000000000E+00 beta (00000215)= 0.126955716189811E+02 gamma(00000215)= 0.126955716189811E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 216 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000216)= 0.000000000000000E+00 beta (00000216)= 0.137084301147383E+02 gamma(00000216)= 0.137084301147383E+02 z1= 1 -0.438189437046519E-07 0.000000000000000E+00 z1= 2 -0.616670701809787E-07 0.000000000000000E+00 z1= 3 -0.319480638855175E-02 0.000000000000000E+00 Lanczos iteration: 217 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000217)= 0.000000000000000E+00 beta (00000217)= 0.129679811627600E+02 gamma(00000217)= 0.129679811627600E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 218 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000218)= 0.000000000000000E+00 beta (00000218)= 0.134105064931911E+02 gamma(00000218)= 0.134105064931911E+02 z1= 1 0.442441595851703E-07 0.000000000000000E+00 z1= 2 0.623211221276957E-07 0.000000000000000E+00 z1= 3 0.309361188523916E-02 0.000000000000000E+00 Lanczos iteration: 219 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000219)= 0.000000000000000E+00 beta (00000219)= 0.125094578316037E+02 gamma(00000219)= 0.125094578316037E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 220 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000220)= 0.000000000000000E+00 beta (00000220)= 0.133534775027903E+02 gamma(00000220)= 0.133534775027903E+02 z1= 1 -0.427074519529329E-07 0.000000000000000E+00 z1= 2 -0.604538654587483E-07 0.000000000000000E+00 z1= 3 -0.290391138615789E-02 0.000000000000000E+00 Lanczos iteration: 221 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000221)= 0.000000000000000E+00 beta (00000221)= 0.126732680321899E+02 gamma(00000221)= 0.126732680321899E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 222 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000222)= 0.000000000000000E+00 beta (00000222)= 0.132759015437273E+02 gamma(00000222)= 0.132759015437273E+02 z1= 1 0.420006494522909E-07 0.000000000000000E+00 z1= 2 0.593971893358448E-07 0.000000000000000E+00 z1= 3 0.277685647756098E-02 0.000000000000000E+00 Lanczos iteration: 223 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000223)= 0.000000000000000E+00 beta (00000223)= 0.124717677137971E+02 gamma(00000223)= 0.124717677137971E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 224 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000224)= 0.000000000000000E+00 beta (00000224)= 0.135248520221106E+02 gamma(00000224)= 0.135248520221106E+02 z1= 1 -0.402108414549514E-07 0.000000000000000E+00 z1= 2 -0.569490954944844E-07 0.000000000000000E+00 z1= 3 -0.256685138741711E-02 0.000000000000000E+00 Lanczos iteration: 225 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000225)= 0.000000000000000E+00 beta (00000225)= 0.127989414545951E+02 gamma(00000225)= 0.127989414545951E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 226 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000226)= 0.000000000000000E+00 beta (00000226)= 0.132563078878572E+02 gamma(00000226)= 0.132563078878572E+02 z1= 1 0.402461134470927E-07 0.000000000000000E+00 z1= 2 0.572976687407065E-07 0.000000000000000E+00 z1= 3 0.248353433096016E-02 0.000000000000000E+00 Lanczos iteration: 227 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000227)= 0.000000000000000E+00 beta (00000227)= 0.121704456530098E+02 gamma(00000227)= 0.121704456530098E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 228 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000228)= 0.000000000000000E+00 beta (00000228)= 0.133980460099959E+02 gamma(00000228)= 0.133980460099959E+02 z1= 1 -0.370864176616956E-07 0.000000000000000E+00 z1= 2 -0.540934538962971E-07 0.000000000000000E+00 z1= 3 -0.226191729334822E-02 0.000000000000000E+00 Lanczos iteration: 229 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000229)= 0.000000000000000E+00 beta (00000229)= 0.128288512934836E+02 gamma(00000229)= 0.128288512934836E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 230 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000230)= 0.000000000000000E+00 beta (00000230)= 0.133144457521177E+02 gamma(00000230)= 0.133144457521177E+02 z1= 1 0.362503051968958E-07 0.000000000000000E+00 z1= 2 0.535380171367769E-07 0.000000000000000E+00 z1= 3 0.218440279039154E-02 0.000000000000000E+00 Lanczos iteration: 231 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000231)= 0.000000000000000E+00 beta (00000231)= 0.126018945230024E+02 gamma(00000231)= 0.126018945230024E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 232 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000232)= 0.000000000000000E+00 beta (00000232)= 0.138146319063164E+02 gamma(00000232)= 0.138146319063164E+02 z1= 1 -0.328639593265138E-07 0.000000000000000E+00 z1= 2 -0.508091128580135E-07 0.000000000000000E+00 z1= 3 -0.199617747424363E-02 0.000000000000000E+00 Lanczos iteration: 233 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000233)= 0.000000000000000E+00 beta (00000233)= 0.130317522553393E+02 gamma(00000233)= 0.130317522553393E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 234 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000234)= 0.000000000000000E+00 beta (00000234)= 0.136720496033384E+02 gamma(00000234)= 0.136720496033384E+02 z1= 1 0.314968663712350E-07 0.000000000000000E+00 z1= 2 0.505162842138682E-07 0.000000000000000E+00 z1= 3 0.190626057635073E-02 0.000000000000000E+00 Lanczos iteration: 235 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000235)= 0.000000000000000E+00 beta (00000235)= 0.129334083527599E+02 gamma(00000235)= 0.129334083527599E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 236 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.4E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000236)= 0.000000000000000E+00 beta (00000236)= 0.133542530660162E+02 gamma(00000236)= 0.133542530660162E+02 z1= 1 -0.297025116915289E-07 0.000000000000000E+00 z1= 2 -0.510391423430567E-07 0.000000000000000E+00 z1= 3 -0.184762307907532E-02 0.000000000000000E+00 Lanczos iteration: 237 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000237)= 0.000000000000000E+00 beta (00000237)= 0.126966007054899E+02 gamma(00000237)= 0.126966007054899E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 238 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.4E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000238)= 0.000000000000000E+00 beta (00000238)= 0.136537090850223E+02 gamma(00000238)= 0.136537090850223E+02 z1= 1 0.272530908848297E-07 0.000000000000000E+00 z1= 2 0.497271808530889E-07 0.000000000000000E+00 z1= 3 0.171963916391087E-02 0.000000000000000E+00 Lanczos iteration: 239 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000239)= 0.000000000000000E+00 beta (00000239)= 0.130073157076165E+02 gamma(00000239)= 0.130073157076165E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 240 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.7E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000240)= 0.000000000000000E+00 beta (00000240)= 0.130840481921263E+02 gamma(00000240)= 0.130840481921263E+02 z1= 1 -0.275550453012700E-07 0.000000000000000E+00 z1= 2 -0.521565043506630E-07 0.000000000000000E+00 z1= 3 -0.170807954471127E-02 0.000000000000000E+00 Lanczos iteration: 241 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000241)= 0.000000000000000E+00 beta (00000241)= 0.124579591476905E+02 gamma(00000241)= 0.124579591476905E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 242 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.4E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000242)= 0.000000000000000E+00 beta (00000242)= 0.133028361650368E+02 gamma(00000242)= 0.133028361650368E+02 z1= 1 0.278099012463199E-07 0.000000000000000E+00 z1= 2 0.523016738971857E-07 0.000000000000000E+00 z1= 3 0.159876792304727E-02 0.000000000000000E+00 Lanczos iteration: 243 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000243)= 0.000000000000000E+00 beta (00000243)= 0.126349096299291E+02 gamma(00000243)= 0.126349096299291E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 244 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.7E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000244)= 0.000000000000000E+00 beta (00000244)= 0.133264971742151E+02 gamma(00000244)= 0.133264971742151E+02 z1= 1 -0.279087731750848E-07 0.000000000000000E+00 z1= 2 -0.526904875039307E-07 0.000000000000000E+00 z1= 3 -0.151183456053242E-02 0.000000000000000E+00 Lanczos iteration: 245 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000245)= 0.000000000000000E+00 beta (00000245)= 0.128796208832434E+02 gamma(00000245)= 0.128796208832434E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 246 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000246)= 0.000000000000000E+00 beta (00000246)= 0.135454289332684E+02 gamma(00000246)= 0.135454289332684E+02 z1= 1 0.275546514071513E-07 0.000000000000000E+00 z1= 2 0.527751536825126E-07 0.000000000000000E+00 z1= 3 0.143463056392823E-02 0.000000000000000E+00 Lanczos iteration: 247 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000247)= 0.000000000000000E+00 beta (00000247)= 0.128870423646695E+02 gamma(00000247)= 0.128870423646695E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 248 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000248)= 0.000000000000000E+00 beta (00000248)= 0.131514270270841E+02 gamma(00000248)= 0.131514270270841E+02 z1= 1 -0.271238154451927E-07 0.000000000000000E+00 z1= 2 -0.539167926407944E-07 0.000000000000000E+00 z1= 3 -0.139924634583153E-02 0.000000000000000E+00 Lanczos iteration: 249 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000249)= 0.000000000000000E+00 beta (00000249)= 0.127341506477494E+02 gamma(00000249)= 0.127341506477494E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 250 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000250)= 0.000000000000000E+00 beta (00000250)= 0.135614121920081E+02 gamma(00000250)= 0.135614121920081E+02 z1= 1 0.261106499791722E-07 0.000000000000000E+00 z1= 2 0.537885442486365E-07 0.000000000000000E+00 z1= 3 0.130894731767841E-02 0.000000000000000E+00 Lanczos iteration: 251 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000251)= 0.000000000000000E+00 beta (00000251)= 0.125569784818158E+02 gamma(00000251)= 0.125569784818158E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 252 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000252)= 0.000000000000000E+00 beta (00000252)= 0.131792328966071E+02 gamma(00000252)= 0.131792328966071E+02 z1= 1 -0.250762606456532E-07 0.000000000000000E+00 z1= 2 -0.556834331272554E-07 0.000000000000000E+00 z1= 3 -0.123780617874833E-02 0.000000000000000E+00 Lanczos iteration: 253 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000253)= 0.000000000000000E+00 beta (00000253)= 0.129206048896717E+02 gamma(00000253)= 0.129206048896717E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 254 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000254)= 0.000000000000000E+00 beta (00000254)= 0.133357057062822E+02 gamma(00000254)= 0.133357057062822E+02 z1= 1 0.263294717469525E-07 0.000000000000000E+00 z1= 2 0.597475721116980E-07 0.000000000000000E+00 z1= 3 0.119070650999130E-02 0.000000000000000E+00 Lanczos iteration: 255 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000255)= 0.000000000000000E+00 beta (00000255)= 0.128066053229999E+02 gamma(00000255)= 0.128066053229999E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 256 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000256)= 0.000000000000000E+00 beta (00000256)= 0.136597237758992E+02 gamma(00000256)= 0.136597237758992E+02 z1= 1 -0.279542975284690E-07 0.000000000000000E+00 z1= 2 -0.609990170208786E-07 0.000000000000000E+00 z1= 3 -0.110395730081656E-02 0.000000000000000E+00 Lanczos iteration: 257 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000257)= 0.000000000000000E+00 beta (00000257)= 0.125704886334185E+02 gamma(00000257)= 0.125704886334185E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 258 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.5E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000258)= 0.000000000000000E+00 beta (00000258)= 0.131199102012470E+02 gamma(00000258)= 0.131199102012470E+02 z1= 1 0.307333930097721E-07 0.000000000000000E+00 z1= 2 0.622599083289089E-07 0.000000000000000E+00 z1= 3 0.104484667288742E-02 0.000000000000000E+00 Lanczos iteration: 259 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000259)= 0.000000000000000E+00 beta (00000259)= 0.124010999512471E+02 gamma(00000259)= 0.124010999512471E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 260 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.5E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000260)= 0.000000000000000E+00 beta (00000260)= 0.132971449014561E+02 gamma(00000260)= 0.132971449014561E+02 z1= 1 -0.321170038181627E-07 0.000000000000000E+00 z1= 2 -0.601494274670052E-07 0.000000000000000E+00 z1= 3 -0.958231244859706E-03 0.000000000000000E+00 Lanczos iteration: 261 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000261)= 0.000000000000000E+00 beta (00000261)= 0.127730733022859E+02 gamma(00000261)= 0.127730733022859E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 262 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.6E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000262)= 0.000000000000000E+00 beta (00000262)= 0.132798102345440E+02 gamma(00000262)= 0.132798102345440E+02 z1= 1 0.332595732691066E-07 0.000000000000000E+00 z1= 2 0.606968804444871E-07 0.000000000000000E+00 z1= 3 0.906415760320241E-03 0.000000000000000E+00 Lanczos iteration: 263 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000263)= 0.000000000000000E+00 beta (00000263)= 0.126525172429375E+02 gamma(00000263)= 0.126525172429375E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 264 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.9E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000264)= 0.000000000000000E+00 beta (00000264)= 0.136137394200690E+02 gamma(00000264)= 0.136137394200690E+02 z1= 1 -0.320247586643729E-07 0.000000000000000E+00 z1= 2 -0.596864592619997E-07 0.000000000000000E+00 z1= 3 -0.825287934345158E-03 0.000000000000000E+00 Lanczos iteration: 265 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000265)= 0.000000000000000E+00 beta (00000265)= 0.127956501962103E+02 gamma(00000265)= 0.127956501962103E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 266 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.0E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000266)= 0.000000000000000E+00 beta (00000266)= 0.132562281869510E+02 gamma(00000266)= 0.132562281869510E+02 z1= 1 0.321437063884392E-07 0.000000000000000E+00 z1= 2 0.617440544603901E-07 0.000000000000000E+00 z1= 3 0.780088737673164E-03 0.000000000000000E+00 Lanczos iteration: 267 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000267)= 0.000000000000000E+00 beta (00000267)= 0.121816161274876E+02 gamma(00000267)= 0.121816161274876E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 268 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.8E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000268)= 0.000000000000000E+00 beta (00000268)= 0.130493733253543E+02 gamma(00000268)= 0.130493733253543E+02 z1= 1 -0.312774710645169E-07 0.000000000000000E+00 z1= 2 -0.610883756791553E-07 0.000000000000000E+00 z1= 3 -0.708861641269792E-03 0.000000000000000E+00 Lanczos iteration: 269 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000269)= 0.000000000000000E+00 beta (00000269)= 0.126889939887020E+02 gamma(00000269)= 0.126889939887020E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 270 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.5E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000270)= 0.000000000000000E+00 beta (00000270)= 0.132863289072770E+02 gamma(00000270)= 0.132863289072770E+02 z1= 1 0.301791243419169E-07 0.000000000000000E+00 z1= 2 0.611898530178401E-07 0.000000000000000E+00 z1= 3 0.661514983467316E-03 0.000000000000000E+00 Lanczos iteration: 271 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000271)= 0.000000000000000E+00 beta (00000271)= 0.125021704183959E+02 gamma(00000271)= 0.125021704183959E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 272 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000272)= 0.000000000000000E+00 beta (00000272)= 0.134831561782856E+02 gamma(00000272)= 0.134831561782856E+02 z1= 1 -0.277918158926842E-07 0.000000000000000E+00 z1= 2 -0.600479054492162E-07 0.000000000000000E+00 z1= 3 -0.594541639407045E-03 0.000000000000000E+00 Lanczos iteration: 273 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000273)= 0.000000000000000E+00 beta (00000273)= 0.127019648145306E+02 gamma(00000273)= 0.127019648145306E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 274 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000274)= 0.000000000000000E+00 beta (00000274)= 0.128550815699887E+02 gamma(00000274)= 0.128550815699887E+02 z1= 1 0.285834783053922E-07 0.000000000000000E+00 z1= 2 0.627016873127467E-07 0.000000000000000E+00 z1= 3 0.573821773367733E-03 0.000000000000000E+00 Lanczos iteration: 275 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000275)= 0.000000000000000E+00 beta (00000275)= 0.130646967207041E+02 gamma(00000275)= 0.130646967207041E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 276 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000276)= 0.000000000000000E+00 beta (00000276)= 0.128780023008241E+02 gamma(00000276)= 0.128780023008241E+02 z1= 1 -0.301241407608607E-07 0.000000000000000E+00 z1= 2 -0.665370433880139E-07 0.000000000000000E+00 z1= 3 -0.563810146554967E-03 0.000000000000000E+00 Lanczos iteration: 277 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000277)= 0.000000000000000E+00 beta (00000277)= 0.124224640438630E+02 gamma(00000277)= 0.124224640438630E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 278 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000278)= 0.000000000000000E+00 beta (00000278)= 0.135504042493292E+02 gamma(00000278)= 0.135504042493292E+02 z1= 1 0.288970900853835E-07 0.000000000000000E+00 z1= 2 0.634376279944060E-07 0.000000000000000E+00 z1= 3 0.510821399114771E-03 0.000000000000000E+00 Lanczos iteration: 279 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000279)= 0.000000000000000E+00 beta (00000279)= 0.123030028254725E+02 gamma(00000279)= 0.123030028254725E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 280 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000280)= 0.000000000000000E+00 beta (00000280)= 0.134863891794379E+02 gamma(00000280)= 0.134863891794379E+02 z1= 1 -0.288313273236109E-07 0.000000000000000E+00 z1= 2 -0.606493706992173E-07 0.000000000000000E+00 z1= 3 -0.448423891695068E-03 0.000000000000000E+00 Lanczos iteration: 281 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000281)= 0.000000000000000E+00 beta (00000281)= 0.130778320762262E+02 gamma(00000281)= 0.130778320762262E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 282 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000282)= 0.000000000000000E+00 beta (00000282)= 0.136188009223834E+02 gamma(00000282)= 0.136188009223834E+02 z1= 1 0.307717230453152E-07 0.000000000000000E+00 z1= 2 0.618746366313344E-07 0.000000000000000E+00 z1= 3 0.431394111820020E-03 0.000000000000000E+00 Lanczos iteration: 283 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000283)= 0.000000000000000E+00 beta (00000283)= 0.130416829657090E+02 gamma(00000283)= 0.130416829657090E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 284 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.7E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000284)= 0.000000000000000E+00 beta (00000284)= 0.133006678263764E+02 gamma(00000284)= 0.133006678263764E+02 z1= 1 -0.334454203306965E-07 0.000000000000000E+00 z1= 2 -0.650164882400744E-07 0.000000000000000E+00 z1= 3 -0.405804629897144E-03 0.000000000000000E+00 Lanczos iteration: 285 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000285)= 0.000000000000000E+00 beta (00000285)= 0.126712315097281E+02 gamma(00000285)= 0.126712315097281E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 286 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000286)= 0.000000000000000E+00 beta (00000286)= 0.136988367469793E+02 gamma(00000286)= 0.136988367469793E+02 z1= 1 0.332032342450302E-07 0.000000000000000E+00 z1= 2 0.650060073799710E-07 0.000000000000000E+00 z1= 3 0.380051661413597E-03 0.000000000000000E+00 Lanczos iteration: 287 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000287)= 0.000000000000000E+00 beta (00000287)= 0.123645762915026E+02 gamma(00000287)= 0.123645762915026E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 288 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000288)= 0.000000000000000E+00 beta (00000288)= 0.137990138500198E+02 gamma(00000288)= 0.137990138500198E+02 z1= 1 -0.309537816220798E-07 0.000000000000000E+00 z1= 2 -0.628715950364879E-07 0.000000000000000E+00 z1= 3 -0.326748331381181E-03 0.000000000000000E+00 Lanczos iteration: 289 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000289)= 0.000000000000000E+00 beta (00000289)= 0.128376649918332E+02 gamma(00000289)= 0.128376649918332E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 290 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.4E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000290)= 0.000000000000000E+00 beta (00000290)= 0.132655986906209E+02 gamma(00000290)= 0.132655986906209E+02 z1= 1 0.309251632662664E-07 0.000000000000000E+00 z1= 2 0.658544999777681E-07 0.000000000000000E+00 z1= 3 0.323344325402403E-03 0.000000000000000E+00 Lanczos iteration: 291 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000291)= 0.000000000000000E+00 beta (00000291)= 0.131213377773291E+02 gamma(00000291)= 0.131213377773291E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 292 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.6E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000292)= 0.000000000000000E+00 beta (00000292)= 0.133875685512096E+02 gamma(00000292)= 0.133875685512096E+02 z1= 1 -0.315014130028066E-07 0.000000000000000E+00 z1= 2 -0.693229934970764E-07 0.000000000000000E+00 z1= 3 -0.306395652775515E-03 0.000000000000000E+00 Lanczos iteration: 293 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000293)= 0.000000000000000E+00 beta (00000293)= 0.123756696644993E+02 gamma(00000293)= 0.123756696644993E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 294 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.2E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000294)= 0.000000000000000E+00 beta (00000294)= 0.136517072063515E+02 gamma(00000294)= 0.136517072063515E+02 z1= 1 0.301990069007867E-07 0.000000000000000E+00 z1= 2 0.678204660408896E-07 0.000000000000000E+00 z1= 3 0.285787885795079E-03 0.000000000000000E+00 Lanczos iteration: 295 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000295)= 0.000000000000000E+00 beta (00000295)= 0.126581609823425E+02 gamma(00000295)= 0.126581609823425E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 296 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.8E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000296)= 0.000000000000000E+00 beta (00000296)= 0.135638097374220E+02 gamma(00000296)= 0.135638097374220E+02 z1= 1 -0.301032745021615E-07 0.000000000000000E+00 z1= 2 -0.686780342838700E-07 0.000000000000000E+00 z1= 3 -0.260362771258078E-03 0.000000000000000E+00 Lanczos iteration: 297 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000297)= 0.000000000000000E+00 beta (00000297)= 0.131901247666891E+02 gamma(00000297)= 0.131901247666891E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 298 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000298)= 0.000000000000000E+00 beta (00000298)= 0.131222489231568E+02 gamma(00000298)= 0.131222489231568E+02 z1= 1 0.329631109089796E-07 0.000000000000000E+00 z1= 2 0.760651343071315E-07 0.000000000000000E+00 z1= 3 0.269882650041318E-03 0.000000000000000E+00 Lanczos iteration: 299 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000299)= 0.000000000000000E+00 beta (00000299)= 0.129072928972968E+02 gamma(00000299)= 0.129072928972968E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 300 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000300)= 0.000000000000000E+00 beta (00000300)= 0.129072956648378E+02 gamma(00000300)= 0.129072956648378E+02 z1= 1 -0.359873770981148E-07 0.000000000000000E+00 z1= 2 -0.835487877087499E-07 0.000000000000000E+00 z1= 3 -0.268797063715041E-03 0.000000000000000E+00 Lanczos iteration: 301 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000301)= 0.000000000000000E+00 beta (00000301)= 0.129078630974024E+02 gamma(00000301)= 0.129078630974024E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 302 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000302)= 0.000000000000000E+00 beta (00000302)= 0.129700398757715E+02 gamma(00000302)= 0.129700398757715E+02 z1= 1 0.389485501837137E-07 0.000000000000000E+00 z1= 2 0.909333196304641E-07 0.000000000000000E+00 z1= 3 0.276303266837370E-03 0.000000000000000E+00 Lanczos iteration: 303 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000303)= 0.000000000000000E+00 beta (00000303)= 0.123952958587988E+02 gamma(00000303)= 0.123952958587988E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 304 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000304)= 0.000000000000000E+00 beta (00000304)= 0.134434999794791E+02 gamma(00000304)= 0.134434999794791E+02 z1= 1 -0.392449348768148E-07 0.000000000000000E+00 z1= 2 -0.917448398306785E-07 0.000000000000000E+00 z1= 3 -0.259780698410698E-03 0.000000000000000E+00 Lanczos iteration: 305 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000305)= 0.000000000000000E+00 beta (00000305)= 0.128209406874527E+02 gamma(00000305)= 0.128209406874527E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 306 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000306)= 0.000000000000000E+00 beta (00000306)= 0.130838873396449E+02 gamma(00000306)= 0.130838873396449E+02 z1= 1 0.423815743755686E-07 0.000000000000000E+00 z1= 2 0.993322780585160E-07 0.000000000000000E+00 z1= 3 0.265641073744174E-03 0.000000000000000E+00 Lanczos iteration: 307 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000307)= 0.000000000000000E+00 beta (00000307)= 0.126539867425468E+02 gamma(00000307)= 0.126539867425468E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 308 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.7E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000308)= 0.000000000000000E+00 beta (00000308)= 0.133764575042038E+02 gamma(00000308)= 0.133764575042038E+02 z1= 1 -0.432397946895568E-07 0.000000000000000E+00 z1= 2 -0.102725249539874E-06 0.000000000000000E+00 z1= 3 -0.259821915220788E-03 0.000000000000000E+00 Lanczos iteration: 309 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000309)= 0.000000000000000E+00 beta (00000309)= 0.126728750067572E+02 gamma(00000309)= 0.126728750067572E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 310 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000310)= 0.000000000000000E+00 beta (00000310)= 0.134248062113467E+02 gamma(00000310)= 0.134248062113467E+02 z1= 1 0.445097280529945E-07 0.000000000000000E+00 z1= 2 0.106311668986669E-06 0.000000000000000E+00 z1= 3 0.256976991930266E-03 0.000000000000000E+00 Lanczos iteration: 311 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000311)= 0.000000000000000E+00 beta (00000311)= 0.124223488917931E+02 gamma(00000311)= 0.124223488917931E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 312 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.3E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000312)= 0.000000000000000E+00 beta (00000312)= 0.134670194388900E+02 gamma(00000312)= 0.134670194388900E+02 z1= 1 -0.438438567836302E-07 0.000000000000000E+00 z1= 2 -0.107720106624399E-06 0.000000000000000E+00 z1= 3 -0.248316936453531E-03 0.000000000000000E+00 Lanczos iteration: 313 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000313)= 0.000000000000000E+00 beta (00000313)= 0.129851939393568E+02 gamma(00000313)= 0.129851939393568E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 314 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.4E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000314)= 0.000000000000000E+00 beta (00000314)= 0.133806573929205E+02 gamma(00000314)= 0.133806573929205E+02 z1= 1 0.460546565676486E-07 0.000000000000000E+00 z1= 2 0.113944796037714E-06 0.000000000000000E+00 z1= 3 0.254026178904521E-03 0.000000000000000E+00 Lanczos iteration: 315 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000315)= 0.000000000000000E+00 beta (00000315)= 0.128244253682098E+02 gamma(00000315)= 0.128244253682098E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 316 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.4E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000316)= 0.000000000000000E+00 beta (00000316)= 0.135296779284403E+02 gamma(00000316)= 0.135296779284403E+02 z1= 1 -0.463328415425956E-07 0.000000000000000E+00 z1= 2 -0.117340107165737E-06 0.000000000000000E+00 z1= 3 -0.254640448948490E-03 0.000000000000000E+00 Lanczos iteration: 317 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000317)= 0.000000000000000E+00 beta (00000317)= 0.125397414136648E+02 gamma(00000317)= 0.125397414136648E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 318 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.3E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000318)= 0.000000000000000E+00 beta (00000318)= 0.130734092838063E+02 gamma(00000318)= 0.130734092838063E+02 z1= 1 0.474642634236931E-07 0.000000000000000E+00 z1= 2 0.123314649931854E-06 0.000000000000000E+00 z1= 3 0.258895590238617E-03 0.000000000000000E+00 Lanczos iteration: 319 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000319)= 0.000000000000000E+00 beta (00000319)= 0.121740910381262E+02 gamma(00000319)= 0.121740910381262E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 320 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000320)= 0.000000000000000E+00 beta (00000320)= 0.133207440389324E+02 gamma(00000320)= 0.133207440389324E+02 z1= 1 -0.443949967135482E-07 0.000000000000000E+00 z1= 2 -0.123456225774267E-06 0.000000000000000E+00 z1= 3 -0.255773867991888E-03 0.000000000000000E+00 Lanczos iteration: 321 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000321)= 0.000000000000000E+00 beta (00000321)= 0.125328805580568E+02 gamma(00000321)= 0.125328805580568E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 322 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.1E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000322)= 0.000000000000000E+00 beta (00000322)= 0.134875319546193E+02 gamma(00000322)= 0.134875319546193E+02 z1= 1 0.439637958130415E-07 0.000000000000000E+00 z1= 2 0.125438389861647E-06 0.000000000000000E+00 z1= 3 0.253578320676795E-03 0.000000000000000E+00 Lanczos iteration: 323 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000323)= 0.000000000000000E+00 beta (00000323)= 0.126350058160511E+02 gamma(00000323)= 0.126350058160511E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 324 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.1E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000324)= 0.000000000000000E+00 beta (00000324)= 0.132959505892729E+02 gamma(00000324)= 0.132959505892729E+02 z1= 1 -0.435686553683715E-07 0.000000000000000E+00 z1= 2 -0.129616160931493E-06 0.000000000000000E+00 z1= 3 -0.266962119829586E-03 0.000000000000000E+00 Lanczos iteration: 325 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000325)= 0.000000000000000E+00 beta (00000325)= 0.126786847055349E+02 gamma(00000325)= 0.126786847055349E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 326 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000326)= 0.000000000000000E+00 beta (00000326)= 0.135699033911509E+02 gamma(00000326)= 0.135699033911509E+02 z1= 1 0.457059753093030E-07 0.000000000000000E+00 z1= 2 0.130681724079193E-06 0.000000000000000E+00 z1= 3 0.265433124319071E-03 0.000000000000000E+00 Lanczos iteration: 327 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000327)= 0.000000000000000E+00 beta (00000327)= 0.126413459252422E+02 gamma(00000327)= 0.126413459252422E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 328 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000328)= 0.000000000000000E+00 beta (00000328)= 0.132477874987756E+02 gamma(00000328)= 0.132477874987756E+02 z1= 1 -0.466777175282210E-07 0.000000000000000E+00 z1= 2 -0.134666817712533E-06 0.000000000000000E+00 z1= 3 -0.287564971299469E-03 0.000000000000000E+00 Lanczos iteration: 329 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000329)= 0.000000000000000E+00 beta (00000329)= 0.124536456981560E+02 gamma(00000329)= 0.124536456981560E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 330 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000330)= 0.000000000000000E+00 beta (00000330)= 0.134732051549016E+02 gamma(00000330)= 0.134732051549016E+02 z1= 1 0.494998742267137E-07 0.000000000000000E+00 z1= 2 0.135622079577152E-06 0.000000000000000E+00 z1= 3 0.282307960388778E-03 0.000000000000000E+00 Lanczos iteration: 331 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000331)= 0.000000000000000E+00 beta (00000331)= 0.129160285453692E+02 gamma(00000331)= 0.129160285453692E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 332 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.0E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000332)= 0.000000000000000E+00 beta (00000332)= 0.134153282070249E+02 gamma(00000332)= 0.134153282070249E+02 z1= 1 -0.495402877843595E-07 0.000000000000000E+00 z1= 2 -0.142241023648156E-06 0.000000000000000E+00 z1= 3 -0.313938846706645E-03 0.000000000000000E+00 Lanczos iteration: 333 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000333)= 0.000000000000000E+00 beta (00000333)= 0.131687448897122E+02 gamma(00000333)= 0.131687448897122E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 334 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.7E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000334)= 0.000000000000000E+00 beta (00000334)= 0.133883472145267E+02 gamma(00000334)= 0.133883472145267E+02 z1= 1 0.552608769596274E-07 0.000000000000000E+00 z1= 2 0.150983600034947E-06 0.000000000000000E+00 z1= 3 0.320704927357404E-03 0.000000000000000E+00 Lanczos iteration: 335 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000335)= 0.000000000000000E+00 beta (00000335)= 0.124019542681864E+02 gamma(00000335)= 0.124019542681864E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 336 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000336)= 0.000000000000000E+00 beta (00000336)= 0.129876981009036E+02 gamma(00000336)= 0.129876981009036E+02 z1= 1 -0.538114110918753E-07 0.000000000000000E+00 z1= 2 -0.156158901292477E-06 0.000000000000000E+00 z1= 3 -0.351741103697779E-03 0.000000000000000E+00 Lanczos iteration: 337 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000337)= 0.000000000000000E+00 beta (00000337)= 0.126220527193255E+02 gamma(00000337)= 0.126220527193255E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 338 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000338)= 0.000000000000000E+00 beta (00000338)= 0.135909592867556E+02 gamma(00000338)= 0.135909592867556E+02 z1= 1 0.573479393574773E-07 0.000000000000000E+00 z1= 2 0.154483763100798E-06 0.000000000000000E+00 z1= 3 0.332018318332475E-03 0.000000000000000E+00 Lanczos iteration: 339 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000339)= 0.000000000000000E+00 beta (00000339)= 0.124348142876393E+02 gamma(00000339)= 0.124348142876393E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 340 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000340)= 0.000000000000000E+00 beta (00000340)= 0.134234233279278E+02 gamma(00000340)= 0.134234233279278E+02 z1= 1 -0.530010803871574E-07 0.000000000000000E+00 z1= 2 -0.154224547194138E-06 0.000000000000000E+00 z1= 3 -0.358775957202632E-03 0.000000000000000E+00 Lanczos iteration: 341 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000341)= 0.000000000000000E+00 beta (00000341)= 0.127741552686370E+02 gamma(00000341)= 0.127741552686370E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 342 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000342)= 0.000000000000000E+00 beta (00000342)= 0.134430668618130E+02 gamma(00000342)= 0.134430668618130E+02 z1= 1 0.608937320060142E-07 0.000000000000000E+00 z1= 2 0.156749231991406E-06 0.000000000000000E+00 z1= 3 0.333281612228141E-03 0.000000000000000E+00 Lanczos iteration: 343 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000343)= 0.000000000000000E+00 beta (00000343)= 0.124269094226234E+02 gamma(00000343)= 0.124269094226234E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 344 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000344)= 0.000000000000000E+00 beta (00000344)= 0.138308252764073E+02 gamma(00000344)= 0.138308252764073E+02 z1= 1 -0.540548619831034E-07 0.000000000000000E+00 z1= 2 -0.154130190134591E-06 0.000000000000000E+00 z1= 3 -0.357620240392799E-03 0.000000000000000E+00 Lanczos iteration: 345 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000345)= 0.000000000000000E+00 beta (00000345)= 0.130374516579157E+02 gamma(00000345)= 0.130374516579157E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 346 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000346)= 0.000000000000000E+00 beta (00000346)= 0.136619151572923E+02 gamma(00000346)= 0.136619151572923E+02 z1= 1 0.640767256241499E-07 0.000000000000000E+00 z1= 2 0.158585233255893E-06 0.000000000000000E+00 z1= 3 0.319336950426734E-03 0.000000000000000E+00 Lanczos iteration: 347 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000347)= 0.000000000000000E+00 beta (00000347)= 0.126952784222927E+02 gamma(00000347)= 0.126952784222927E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 348 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000348)= 0.000000000000000E+00 beta (00000348)= 0.136501100790272E+02 gamma(00000348)= 0.136501100790272E+02 z1= 1 -0.589361793771215E-07 0.000000000000000E+00 z1= 2 -0.162431451057935E-06 0.000000000000000E+00 z1= 3 -0.354869056276057E-03 0.000000000000000E+00 Lanczos iteration: 349 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000349)= 0.000000000000000E+00 beta (00000349)= 0.129398437045134E+02 gamma(00000349)= 0.129398437045134E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 350 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000350)= 0.000000000000000E+00 beta (00000350)= 0.133042882702991E+02 gamma(00000350)= 0.133042882702991E+02 z1= 1 0.692772361955913E-07 0.000000000000000E+00 z1= 2 0.170917135883155E-06 0.000000000000000E+00 z1= 3 0.326624337021474E-03 0.000000000000000E+00 Lanczos iteration: 351 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000351)= 0.000000000000000E+00 beta (00000351)= 0.126895370970797E+02 gamma(00000351)= 0.126895370970797E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 352 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.2E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000352)= 0.000000000000000E+00 beta (00000352)= 0.131166598786086E+02 gamma(00000352)= 0.131166598786086E+02 z1= 1 -0.675605143181986E-07 0.000000000000000E+00 z1= 2 -0.181120854713204E-06 0.000000000000000E+00 z1= 3 -0.361050138825349E-03 0.000000000000000E+00 Lanczos iteration: 353 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000353)= 0.000000000000000E+00 beta (00000353)= 0.131365158875140E+02 gamma(00000353)= 0.131365158875140E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 354 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000354)= 0.000000000000000E+00 beta (00000354)= 0.131768037950228E+02 gamma(00000354)= 0.131768037950228E+02 z1= 1 0.766523599469906E-07 0.000000000000000E+00 z1= 2 0.195271726964965E-06 0.000000000000000E+00 z1= 3 0.348503645169662E-03 0.000000000000000E+00 Lanczos iteration: 355 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000355)= 0.000000000000000E+00 beta (00000355)= 0.126606004197643E+02 gamma(00000355)= 0.126606004197643E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 356 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000356)= 0.000000000000000E+00 beta (00000356)= 0.134015702534132E+02 gamma(00000356)= 0.134015702534132E+02 z1= 1 -0.741821511063452E-07 0.000000000000000E+00 z1= 2 -0.199602490562529E-06 0.000000000000000E+00 z1= 3 -0.357479099088320E-03 0.000000000000000E+00 Lanczos iteration: 357 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000357)= 0.000000000000000E+00 beta (00000357)= 0.126672216995992E+02 gamma(00000357)= 0.126672216995992E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 358 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000358)= 0.000000000000000E+00 beta (00000358)= 0.134009107151803E+02 gamma(00000358)= 0.134009107151803E+02 z1= 1 0.784852211622219E-07 0.000000000000000E+00 z1= 2 0.203823898028738E-06 0.000000000000000E+00 z1= 3 0.331458756489104E-03 0.000000000000000E+00 Lanczos iteration: 359 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000359)= 0.000000000000000E+00 beta (00000359)= 0.125905975889821E+02 gamma(00000359)= 0.125905975889821E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 360 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000360)= 0.000000000000000E+00 beta (00000360)= 0.134398801749646E+02 gamma(00000360)= 0.134398801749646E+02 z1= 1 -0.778893948328663E-07 0.000000000000000E+00 z1= 2 -0.205295573105463E-06 0.000000000000000E+00 z1= 3 -0.325925674308408E-03 0.000000000000000E+00 Lanczos iteration: 361 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000361)= 0.000000000000000E+00 beta (00000361)= 0.122152726046088E+02 gamma(00000361)= 0.122152726046088E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 362 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000362)= 0.000000000000000E+00 beta (00000362)= 0.132245814928935E+02 gamma(00000362)= 0.132245814928935E+02 z1= 1 0.810031968976905E-07 0.000000000000000E+00 z1= 2 0.204821726188897E-06 0.000000000000000E+00 z1= 3 0.297996450015322E-03 0.000000000000000E+00 Lanczos iteration: 363 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000363)= 0.000000000000000E+00 beta (00000363)= 0.124894949616934E+02 gamma(00000363)= 0.124894949616934E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 364 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.6E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000364)= 0.000000000000000E+00 beta (00000364)= 0.132936650570723E+02 gamma(00000364)= 0.132936650570723E+02 z1= 1 -0.810807740621636E-07 0.000000000000000E+00 z1= 2 -0.209907600642683E-06 0.000000000000000E+00 z1= 3 -0.287082871052201E-03 0.000000000000000E+00 Lanczos iteration: 365 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000365)= 0.000000000000000E+00 beta (00000365)= 0.126231319491741E+02 gamma(00000365)= 0.126231319491741E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 366 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.9E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000366)= 0.000000000000000E+00 beta (00000366)= 0.129059168507936E+02 gamma(00000366)= 0.129059168507936E+02 z1= 1 0.882354964041189E-07 0.000000000000000E+00 z1= 2 0.224380599635958E-06 0.000000000000000E+00 z1= 3 0.277806008696881E-03 0.000000000000000E+00 Lanczos iteration: 367 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000367)= 0.000000000000000E+00 beta (00000367)= 0.124422270264817E+02 gamma(00000367)= 0.124422270264817E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 368 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.3E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000368)= 0.000000000000000E+00 beta (00000368)= 0.136426968355504E+02 gamma(00000368)= 0.136426968355504E+02 z1= 1 -0.838784371198168E-07 0.000000000000000E+00 z1= 2 -0.222210638200484E-06 0.000000000000000E+00 z1= 3 -0.254005339221259E-03 0.000000000000000E+00 Lanczos iteration: 369 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000369)= 0.000000000000000E+00 beta (00000369)= 0.128093335961652E+02 gamma(00000369)= 0.128093335961652E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 370 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.3E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000370)= 0.000000000000000E+00 beta (00000370)= 0.134556225442524E+02 gamma(00000370)= 0.134556225442524E+02 z1= 1 0.890487388378815E-07 0.000000000000000E+00 z1= 2 0.229625018907426E-06 0.000000000000000E+00 z1= 3 0.236235095132686E-03 0.000000000000000E+00 Lanczos iteration: 371 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000371)= 0.000000000000000E+00 beta (00000371)= 0.123746911964460E+02 gamma(00000371)= 0.123746911964460E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 372 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.8E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000372)= 0.000000000000000E+00 beta (00000372)= 0.131576360597472E+02 gamma(00000372)= 0.131576360597472E+02 z1= 1 -0.866735097363163E-07 0.000000000000000E+00 z1= 2 -0.235738368242050E-06 0.000000000000000E+00 z1= 3 -0.218167763660182E-03 0.000000000000000E+00 Lanczos iteration: 373 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000373)= 0.000000000000000E+00 beta (00000373)= 0.127721742116480E+02 gamma(00000373)= 0.127721742116480E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 374 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.4E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000374)= 0.000000000000000E+00 beta (00000374)= 0.136706070716402E+02 gamma(00000374)= 0.136706070716402E+02 z1= 1 0.925785258690682E-07 0.000000000000000E+00 z1= 2 0.238434780060919E-06 0.000000000000000E+00 z1= 3 0.197692076973170E-03 0.000000000000000E+00 Lanczos iteration: 375 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000375)= 0.000000000000000E+00 beta (00000375)= 0.128191443898044E+02 gamma(00000375)= 0.128191443898044E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 376 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000376)= 0.000000000000000E+00 beta (00000376)= 0.134509938321579E+02 gamma(00000376)= 0.134509938321579E+02 z1= 1 -0.889085434805509E-07 0.000000000000000E+00 z1= 2 -0.246991381654582E-06 0.000000000000000E+00 z1= 3 -0.182700685980336E-03 0.000000000000000E+00 Lanczos iteration: 377 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000377)= 0.000000000000000E+00 beta (00000377)= 0.124611979458755E+02 gamma(00000377)= 0.124611979458755E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 378 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.7E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000378)= 0.000000000000000E+00 beta (00000378)= 0.131575860249777E+02 gamma(00000378)= 0.131575860249777E+02 z1= 1 0.968494045135160E-07 0.000000000000000E+00 z1= 2 0.255433247123402E-06 0.000000000000000E+00 z1= 3 0.166891993818353E-03 0.000000000000000E+00 Lanczos iteration: 379 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000379)= 0.000000000000000E+00 beta (00000379)= 0.124285557061854E+02 gamma(00000379)= 0.124285557061854E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 380 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.7E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000380)= 0.000000000000000E+00 beta (00000380)= 0.131318714512417E+02 gamma(00000380)= 0.131318714512417E+02 z1= 1 -0.896925282118516E-07 0.000000000000000E+00 z1= 2 -0.264117401478333E-06 0.000000000000000E+00 z1= 3 -0.149728470208940E-03 0.000000000000000E+00 Lanczos iteration: 381 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000381)= 0.000000000000000E+00 beta (00000381)= 0.126462554642264E+02 gamma(00000381)= 0.126462554642264E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 382 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000382)= 0.000000000000000E+00 beta (00000382)= 0.134598496253129E+02 gamma(00000382)= 0.134598496253129E+02 z1= 1 0.102093819178859E-06 0.000000000000000E+00 z1= 2 0.268526068163740E-06 0.000000000000000E+00 z1= 3 0.135919628539986E-03 0.000000000000000E+00 Lanczos iteration: 383 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000383)= 0.000000000000000E+00 beta (00000383)= 0.125009591276844E+02 gamma(00000383)= 0.125009591276844E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 384 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000384)= 0.000000000000000E+00 beta (00000384)= 0.131940873226997E+02 gamma(00000384)= 0.131940873226997E+02 z1= 1 -0.892346167745677E-07 0.000000000000000E+00 z1= 2 -0.276878100873923E-06 0.000000000000000E+00 z1= 3 -0.120254193026931E-03 0.000000000000000E+00 Lanczos iteration: 385 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000385)= 0.000000000000000E+00 beta (00000385)= 0.125637243356754E+02 gamma(00000385)= 0.125637243356754E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 386 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000386)= 0.000000000000000E+00 beta (00000386)= 0.130279016719080E+02 gamma(00000386)= 0.130279016719080E+02 z1= 1 0.115991818890439E-06 0.000000000000000E+00 z1= 2 0.288253288762124E-06 0.000000000000000E+00 z1= 3 0.114385994647380E-03 0.000000000000000E+00 Lanczos iteration: 387 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000387)= 0.000000000000000E+00 beta (00000387)= 0.125569301801541E+02 gamma(00000387)= 0.125569301801541E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 388 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.8E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000388)= 0.000000000000000E+00 beta (00000388)= 0.136334003556128E+02 gamma(00000388)= 0.136334003556128E+02 z1= 1 -0.850932471852927E-07 0.000000000000000E+00 z1= 2 -0.288337598685533E-06 0.000000000000000E+00 z1= 3 -0.981191677801065E-04 0.000000000000000E+00 Lanczos iteration: 389 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000389)= 0.000000000000000E+00 beta (00000389)= 0.127309491358714E+02 gamma(00000389)= 0.127309491358714E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 390 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.0E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000390)= 0.000000000000000E+00 beta (00000390)= 0.131557965351491E+02 gamma(00000390)= 0.131557965351491E+02 z1= 1 0.130480036869291E-06 0.000000000000000E+00 z1= 2 0.301162878414175E-06 0.000000000000000E+00 z1= 3 0.979877877347046E-04 0.000000000000000E+00 Lanczos iteration: 391 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000391)= 0.000000000000000E+00 beta (00000391)= 0.127908873169733E+02 gamma(00000391)= 0.127908873169733E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 392 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000392)= 0.000000000000000E+00 beta (00000392)= 0.134330778052759E+02 gamma(00000392)= 0.134330778052759E+02 z1= 1 -0.818917017832415E-07 0.000000000000000E+00 z1= 2 -0.311098418281355E-06 0.000000000000000E+00 z1= 3 -0.861284603449822E-04 0.000000000000000E+00 Lanczos iteration: 393 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000393)= 0.000000000000000E+00 beta (00000393)= 0.126881317031358E+02 gamma(00000393)= 0.126881317031358E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 394 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000394)= 0.000000000000000E+00 beta (00000394)= 0.136692156056257E+02 gamma(00000394)= 0.136692156056257E+02 z1= 1 0.144442109737374E-06 0.000000000000000E+00 z1= 2 0.309285043128410E-06 0.000000000000000E+00 z1= 3 0.852064045180657E-04 0.000000000000000E+00 Lanczos iteration: 395 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000395)= 0.000000000000000E+00 beta (00000395)= 0.125368562995210E+02 gamma(00000395)= 0.125368562995210E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 396 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000396)= 0.000000000000000E+00 beta (00000396)= 0.133089862305856E+02 gamma(00000396)= 0.133089862305856E+02 z1= 1 -0.724785344152681E-07 0.000000000000000E+00 z1= 2 -0.318744794532925E-06 0.000000000000000E+00 z1= 3 -0.704780993234684E-04 0.000000000000000E+00 Lanczos iteration: 397 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000397)= 0.000000000000000E+00 beta (00000397)= 0.128653672023001E+02 gamma(00000397)= 0.128653672023001E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 398 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000398)= 0.000000000000000E+00 beta (00000398)= 0.137275669758769E+02 gamma(00000398)= 0.137275669758769E+02 z1= 1 0.159011919459787E-06 0.000000000000000E+00 z1= 2 0.320034245173805E-06 0.000000000000000E+00 z1= 3 0.696081715588007E-04 0.000000000000000E+00 Lanczos iteration: 399 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000399)= 0.000000000000000E+00 beta (00000399)= 0.123832872457333E+02 gamma(00000399)= 0.123832872457333E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 400 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000400)= 0.000000000000000E+00 beta (00000400)= 0.131535454324262E+02 gamma(00000400)= 0.131535454324262E+02 z1= 1 -0.676688712603242E-07 0.000000000000000E+00 z1= 2 -0.333967407865551E-06 0.000000000000000E+00 z1= 3 -0.508883047854944E-04 0.000000000000000E+00 Lanczos iteration: 401 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000401)= 0.000000000000000E+00 beta (00000401)= 0.125260675032785E+02 gamma(00000401)= 0.125260675032785E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 402 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.4E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000402)= 0.000000000000000E+00 beta (00000402)= 0.134808877040180E+02 gamma(00000402)= 0.134808877040180E+02 z1= 1 0.188230551270924E-06 0.000000000000000E+00 z1= 2 0.335184359671371E-06 0.000000000000000E+00 z1= 3 0.466845545676851E-04 0.000000000000000E+00 Lanczos iteration: 403 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000403)= 0.000000000000000E+00 beta (00000403)= 0.125316139474293E+02 gamma(00000403)= 0.125316139474293E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 404 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.8E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000404)= 0.000000000000000E+00 beta (00000404)= 0.131435747864816E+02 gamma(00000404)= 0.131435747864816E+02 z1= 1 -0.489454741114340E-07 0.000000000000000E+00 z1= 2 -0.358835678720450E-06 0.000000000000000E+00 z1= 3 -0.194827989696209E-04 0.000000000000000E+00 Lanczos iteration: 405 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000405)= 0.000000000000000E+00 beta (00000405)= 0.124563235582458E+02 gamma(00000405)= 0.124563235582458E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 406 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.0E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000406)= 0.000000000000000E+00 beta (00000406)= 0.137337259946830E+02 gamma(00000406)= 0.137337259946830E+02 z1= 1 0.241626342516372E-06 0.000000000000000E+00 z1= 2 0.350579146111800E-06 0.000000000000000E+00 z1= 3 0.150703872690283E-04 0.000000000000000E+00 Lanczos iteration: 407 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000407)= 0.000000000000000E+00 beta (00000407)= 0.125480556216672E+02 gamma(00000407)= 0.125480556216672E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 408 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.9E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000408)= 0.000000000000000E+00 beta (00000408)= 0.131210670772072E+02 gamma(00000408)= 0.131210670772072E+02 z1= 1 0.230602163688205E-08 0.000000000000000E+00 z1= 2 -0.386056628907949E-06 0.000000000000000E+00 z1= 3 0.253837731634295E-04 0.000000000000000E+00 Lanczos iteration: 409 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000409)= 0.000000000000000E+00 beta (00000409)= 0.128876017238930E+02 gamma(00000409)= 0.128876017238930E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 410 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.7E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000410)= 0.000000000000000E+00 beta (00000410)= 0.136023733249854E+02 gamma(00000410)= 0.136023733249854E+02 z1= 1 0.316566067032754E-06 0.000000000000000E+00 z1= 2 0.390494514626149E-06 0.000000000000000E+00 z1= 3 -0.245370311817393E-04 0.000000000000000E+00 Lanczos iteration: 411 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000411)= 0.000000000000000E+00 beta (00000411)= 0.126850765324852E+02 gamma(00000411)= 0.126850765324852E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 412 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.3E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000412)= 0.000000000000000E+00 beta (00000412)= 0.135107792017668E+02 gamma(00000412)= 0.135107792017668E+02 z1= 1 0.553306051537662E-07 0.000000000000000E+00 z1= 2 -0.425297395661561E-06 0.000000000000000E+00 z1= 3 0.764050501559574E-04 0.000000000000000E+00 Lanczos iteration: 413 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000413)= 0.000000000000000E+00 beta (00000413)= 0.127196295652175E+02 gamma(00000413)= 0.127196295652175E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 414 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000414)= 0.000000000000000E+00 beta (00000414)= 0.138193665618190E+02 gamma(00000414)= 0.138193665618190E+02 z1= 1 0.362999210996829E-06 0.000000000000000E+00 z1= 2 0.414430577056011E-06 0.000000000000000E+00 z1= 3 -0.692666094065826E-04 0.000000000000000E+00 Lanczos iteration: 415 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000415)= 0.000000000000000E+00 beta (00000415)= 0.127184942017273E+02 gamma(00000415)= 0.127184942017273E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 416 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000416)= 0.000000000000000E+00 beta (00000416)= 0.134186793120656E+02 gamma(00000416)= 0.134186793120656E+02 z1= 1 0.654325865939807E-07 0.000000000000000E+00 z1= 2 -0.458213446916014E-06 0.000000000000000E+00 z1= 3 0.129218799722060E-03 0.000000000000000E+00 Lanczos iteration: 417 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000417)= 0.000000000000000E+00 beta (00000417)= 0.125874003943688E+02 gamma(00000417)= 0.125874003943688E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 418 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000418)= 0.000000000000000E+00 beta (00000418)= 0.135728141137514E+02 gamma(00000418)= 0.135728141137514E+02 z1= 1 0.376116706299367E-06 0.000000000000000E+00 z1= 2 0.451401518642390E-06 0.000000000000000E+00 z1= 3 -0.123466053304926E-03 0.000000000000000E+00 Lanczos iteration: 419 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000419)= 0.000000000000000E+00 beta (00000419)= 0.130789395106435E+02 gamma(00000419)= 0.130789395106435E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 420 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000420)= 0.000000000000000E+00 beta (00000420)= 0.137311188831660E+02 gamma(00000420)= 0.137311188831660E+02 z1= 1 0.375905628385268E-07 0.000000000000000E+00 z1= 2 -0.494981509912380E-06 0.000000000000000E+00 z1= 3 0.183594736309051E-03 0.000000000000000E+00 Lanczos iteration: 421 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000421)= 0.000000000000000E+00 beta (00000421)= 0.125007575814502E+02 gamma(00000421)= 0.125007575814502E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 422 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000422)= 0.000000000000000E+00 beta (00000422)= 0.132614009741602E+02 gamma(00000422)= 0.132614009741602E+02 z1= 1 0.341173361264474E-06 0.000000000000000E+00 z1= 2 0.499263050294163E-06 0.000000000000000E+00 z1= 3 -0.186965306694480E-03 0.000000000000000E+00 Lanczos iteration: 423 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000423)= 0.000000000000000E+00 beta (00000423)= 0.127440709711783E+02 gamma(00000423)= 0.127440709711783E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 424 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000424)= 0.000000000000000E+00 beta (00000424)= 0.136552446304886E+02 gamma(00000424)= 0.136552446304886E+02 z1= 1 -0.308346503828097E-07 0.000000000000000E+00 z1= 2 -0.529022511995287E-06 0.000000000000000E+00 z1= 3 0.236368777724184E-03 0.000000000000000E+00 Lanczos iteration: 425 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000425)= 0.000000000000000E+00 beta (00000425)= 0.128908092911590E+02 gamma(00000425)= 0.128908092911590E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 426 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000426)= 0.000000000000000E+00 beta (00000426)= 0.132310316818280E+02 gamma(00000426)= 0.132310316818280E+02 z1= 1 0.305595010577570E-06 0.000000000000000E+00 z1= 2 0.555422280148305E-06 0.000000000000000E+00 z1= 3 -0.254515843046386E-03 0.000000000000000E+00 Lanczos iteration: 427 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000427)= 0.000000000000000E+00 beta (00000427)= 0.123631755052732E+02 gamma(00000427)= 0.123631755052732E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 428 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.1E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000428)= 0.000000000000000E+00 beta (00000428)= 0.134852065201584E+02 gamma(00000428)= 0.134852065201584E+02 z1= 1 -0.105705903638684E-06 0.000000000000000E+00 z1= 2 -0.573019349846076E-06 0.000000000000000E+00 z1= 3 0.289474353956071E-03 0.000000000000000E+00 Lanczos iteration: 429 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000429)= 0.000000000000000E+00 beta (00000429)= 0.125047802006484E+02 gamma(00000429)= 0.125047802006484E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 430 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000430)= 0.000000000000000E+00 beta (00000430)= 0.134597832335931E+02 gamma(00000430)= 0.134597832335931E+02 z1= 1 0.280188016736475E-06 0.000000000000000E+00 z1= 2 0.582867403883856E-06 0.000000000000000E+00 z1= 3 -0.304289041650849E-03 0.000000000000000E+00 Lanczos iteration: 431 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000431)= 0.000000000000000E+00 beta (00000431)= 0.124026311013817E+02 gamma(00000431)= 0.124026311013817E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 432 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.3E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000432)= 0.000000000000000E+00 beta (00000432)= 0.134519798116367E+02 gamma(00000432)= 0.134519798116367E+02 z1= 1 -0.142696179314676E-06 0.000000000000000E+00 z1= 2 -0.605132620189663E-06 0.000000000000000E+00 z1= 3 0.333774147215315E-03 0.000000000000000E+00 Lanczos iteration: 433 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000433)= 0.000000000000000E+00 beta (00000433)= 0.123228465728191E+02 gamma(00000433)= 0.123228465728191E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 434 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.4E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000434)= 0.000000000000000E+00 beta (00000434)= 0.135156998142756E+02 gamma(00000434)= 0.135156998142756E+02 z1= 1 0.277947365114333E-06 0.000000000000000E+00 z1= 2 0.610289048147487E-06 0.000000000000000E+00 z1= 3 -0.348718198790336E-03 0.000000000000000E+00 Lanczos iteration: 435 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000435)= 0.000000000000000E+00 beta (00000435)= 0.126064425124250E+02 gamma(00000435)= 0.126064425124250E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 436 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.4E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000436)= 0.000000000000000E+00 beta (00000436)= 0.134741095882207E+02 gamma(00000436)= 0.134741095882207E+02 z1= 1 -0.155147607950657E-06 0.000000000000000E+00 z1= 2 -0.644602604494681E-06 0.000000000000000E+00 z1= 3 0.376619222402404E-03 0.000000000000000E+00 Lanczos iteration: 437 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000437)= 0.000000000000000E+00 beta (00000437)= 0.122766131677984E+02 gamma(00000437)= 0.122766131677984E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 438 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.2E-13, # of iterations = 16 lr_apply_liouvillian: applying interaction: normal alpha(00000438)= 0.000000000000000E+00 beta (00000438)= 0.131438004222440E+02 gamma(00000438)= 0.131438004222440E+02 z1= 1 0.304872364039691E-06 0.000000000000000E+00 z1= 2 0.667626066216975E-06 0.000000000000000E+00 z1= 3 -0.404068849919725E-03 0.000000000000000E+00 Lanczos iteration: 439 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000439)= 0.000000000000000E+00 beta (00000439)= 0.126686407435810E+02 gamma(00000439)= 0.126686407435810E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 440 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000440)= 0.000000000000000E+00 beta (00000440)= 0.133318566989305E+02 gamma(00000440)= 0.133318566989305E+02 z1= 1 -0.149842663757960E-06 0.000000000000000E+00 z1= 2 -0.715103759890527E-06 0.000000000000000E+00 z1= 3 0.430286811835514E-03 0.000000000000000E+00 Lanczos iteration: 441 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000441)= 0.000000000000000E+00 beta (00000441)= 0.127271638800710E+02 gamma(00000441)= 0.127271638800710E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 442 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.3E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000442)= 0.000000000000000E+00 beta (00000442)= 0.134991877475941E+02 gamma(00000442)= 0.134991877475941E+02 z1= 1 0.367719591544587E-06 0.000000000000000E+00 z1= 2 0.738058937727439E-06 0.000000000000000E+00 z1= 3 -0.457810959218635E-03 0.000000000000000E+00 Lanczos iteration: 443 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000443)= 0.000000000000000E+00 beta (00000443)= 0.125410673917918E+02 gamma(00000443)= 0.125410673917918E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 444 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000444)= 0.000000000000000E+00 beta (00000444)= 0.135461287550625E+02 gamma(00000444)= 0.135461287550625E+02 z1= 1 -0.126751901628069E-06 0.000000000000000E+00 z1= 2 -0.772799799072252E-06 0.000000000000000E+00 z1= 3 0.463160022834658E-03 0.000000000000000E+00 Lanczos iteration: 445 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000445)= 0.000000000000000E+00 beta (00000445)= 0.124307156068227E+02 gamma(00000445)= 0.124307156068227E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 446 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 7.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000446)= 0.000000000000000E+00 beta (00000446)= 0.136301016450533E+02 gamma(00000446)= 0.136301016450533E+02 z1= 1 0.432008687717726E-06 0.000000000000000E+00 z1= 2 0.771549684365404E-06 0.000000000000000E+00 z1= 3 -0.477795081933238E-03 0.000000000000000E+00 Lanczos iteration: 447 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000447)= 0.000000000000000E+00 beta (00000447)= 0.127543331530668E+02 gamma(00000447)= 0.127543331530668E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 448 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.7E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000448)= 0.000000000000000E+00 beta (00000448)= 0.133026602271565E+02 gamma(00000448)= 0.133026602271565E+02 z1= 1 -0.966145576983442E-07 0.000000000000000E+00 z1= 2 -0.843296396616823E-06 0.000000000000000E+00 z1= 3 0.493216948887414E-03 0.000000000000000E+00 Lanczos iteration: 449 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000449)= 0.000000000000000E+00 beta (00000449)= 0.128021293374016E+02 gamma(00000449)= 0.128021293374016E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 450 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000450)= 0.000000000000000E+00 beta (00000450)= 0.134714623758000E+02 gamma(00000450)= 0.134714623758000E+02 z1= 1 0.516514242940975E-06 0.000000000000000E+00 z1= 2 0.867261942353106E-06 0.000000000000000E+00 z1= 3 -0.527194040956511E-03 0.000000000000000E+00 Lanczos iteration: 451 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000451)= 0.000000000000000E+00 beta (00000451)= 0.125883406464608E+02 gamma(00000451)= 0.125883406464608E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 452 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000452)= 0.000000000000000E+00 beta (00000452)= 0.133801710764476E+02 gamma(00000452)= 0.133801710764476E+02 z1= 1 -0.649824946520735E-07 0.000000000000000E+00 z1= 2 -0.928517054017523E-06 0.000000000000000E+00 z1= 3 0.524796840183250E-03 0.000000000000000E+00 Lanczos iteration: 453 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000453)= 0.000000000000000E+00 beta (00000453)= 0.128148410528940E+02 gamma(00000453)= 0.128148410528940E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 454 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000454)= 0.000000000000000E+00 beta (00000454)= 0.136415280400829E+02 gamma(00000454)= 0.136415280400829E+02 z1= 1 0.599152475473002E-06 0.000000000000000E+00 z1= 2 0.937522421722101E-06 0.000000000000000E+00 z1= 3 -0.553811245971363E-03 0.000000000000000E+00 Lanczos iteration: 455 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000455)= 0.000000000000000E+00 beta (00000455)= 0.122805449449983E+02 gamma(00000455)= 0.122805449449983E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 456 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000456)= 0.000000000000000E+00 beta (00000456)= 0.136653672712712E+02 gamma(00000456)= 0.136653672712712E+02 z1= 1 -0.115916691248918E-07 0.000000000000000E+00 z1= 2 -0.969963145751275E-06 0.000000000000000E+00 z1= 3 0.521765641567678E-03 0.000000000000000E+00 Lanczos iteration: 457 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000457)= 0.000000000000000E+00 beta (00000457)= 0.129433167602779E+02 gamma(00000457)= 0.129433167602779E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 458 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000458)= 0.000000000000000E+00 beta (00000458)= 0.134982866127529E+02 gamma(00000458)= 0.134982866127529E+02 z1= 1 0.670758952948372E-06 0.000000000000000E+00 z1= 2 0.100150842562608E-05 0.000000000000000E+00 z1= 3 -0.568430544602636E-03 0.000000000000000E+00 Lanczos iteration: 459 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000459)= 0.000000000000000E+00 beta (00000459)= 0.129517809961451E+02 gamma(00000459)= 0.129517809961451E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 460 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.4E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000460)= 0.000000000000000E+00 beta (00000460)= 0.137210928595641E+02 gamma(00000460)= 0.137210928595641E+02 z1= 1 -0.548979137918052E-07 0.000000000000000E+00 z1= 2 -0.107949676237317E-05 0.000000000000000E+00 z1= 3 0.558205708555574E-03 0.000000000000000E+00 Lanczos iteration: 461 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000461)= 0.000000000000000E+00 beta (00000461)= 0.125927400471167E+02 gamma(00000461)= 0.125927400471167E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 462 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000462)= 0.000000000000000E+00 beta (00000462)= 0.133930581813505E+02 gamma(00000462)= 0.133930581813505E+02 z1= 1 0.647783227293347E-06 0.000000000000000E+00 z1= 2 0.109813028508973E-05 0.000000000000000E+00 z1= 3 -0.592820964181597E-03 0.000000000000000E+00 Lanczos iteration: 463 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000463)= 0.000000000000000E+00 beta (00000463)= 0.127197185288540E+02 gamma(00000463)= 0.127197185288540E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 464 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000464)= 0.000000000000000E+00 beta (00000464)= 0.133129935207810E+02 gamma(00000464)= 0.133129935207810E+02 z1= 1 -0.158287985731502E-06 0.000000000000000E+00 z1= 2 -0.118971087681246E-05 0.000000000000000E+00 z1= 3 0.595950215550312E-03 0.000000000000000E+00 Lanczos iteration: 465 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000465)= 0.000000000000000E+00 beta (00000465)= 0.127242728098524E+02 gamma(00000465)= 0.127242728098524E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 466 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000466)= 0.000000000000000E+00 beta (00000466)= 0.134182916496616E+02 gamma(00000466)= 0.134182916496616E+02 z1= 1 0.640599807265698E-06 0.000000000000000E+00 z1= 2 0.122137933563911E-05 0.000000000000000E+00 z1= 3 -0.631485951924311E-03 0.000000000000000E+00 Lanczos iteration: 467 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000467)= 0.000000000000000E+00 beta (00000467)= 0.127642959155950E+02 gamma(00000467)= 0.127642959155950E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 468 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000468)= 0.000000000000000E+00 beta (00000468)= 0.135739632440721E+02 gamma(00000468)= 0.135739632440721E+02 z1= 1 -0.235869711129951E-06 0.000000000000000E+00 z1= 2 -0.128831089047125E-05 0.000000000000000E+00 z1= 3 0.627069153906389E-03 0.000000000000000E+00 Lanczos iteration: 469 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000469)= 0.000000000000000E+00 beta (00000469)= 0.125419384393698E+02 gamma(00000469)= 0.125419384393698E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 470 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.6E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000470)= 0.000000000000000E+00 beta (00000470)= 0.136347071646343E+02 gamma(00000470)= 0.136347071646343E+02 z1= 1 0.613972144801835E-06 0.000000000000000E+00 z1= 2 0.129202431303418E-05 0.000000000000000E+00 z1= 3 -0.643806208385861E-03 0.000000000000000E+00 Lanczos iteration: 471 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000471)= 0.000000000000000E+00 beta (00000471)= 0.129030012309972E+02 gamma(00000471)= 0.129030012309972E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 472 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.7E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000472)= 0.000000000000000E+00 beta (00000472)= 0.131620852122772E+02 gamma(00000472)= 0.131620852122772E+02 z1= 1 -0.337786981737366E-06 0.000000000000000E+00 z1= 2 -0.141690672722473E-05 0.000000000000000E+00 z1= 3 0.673674856271768E-03 0.000000000000000E+00 Lanczos iteration: 473 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000473)= 0.000000000000000E+00 beta (00000473)= 0.127833696496754E+02 gamma(00000473)= 0.127833696496754E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 474 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000474)= 0.000000000000000E+00 beta (00000474)= 0.135771800982027E+02 gamma(00000474)= 0.135771800982027E+02 z1= 1 0.602863103402163E-06 0.000000000000000E+00 z1= 2 0.145133727173373E-05 0.000000000000000E+00 z1= 3 -0.699003896266849E-03 0.000000000000000E+00 Lanczos iteration: 475 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000475)= 0.000000000000000E+00 beta (00000475)= 0.126226715349132E+02 gamma(00000475)= 0.126226715349132E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 476 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000476)= 0.000000000000000E+00 beta (00000476)= 0.130124197957417E+02 gamma(00000476)= 0.130124197957417E+02 z1= 1 -0.448472355748923E-06 0.000000000000000E+00 z1= 2 -0.156036904236313E-05 0.000000000000000E+00 z1= 3 0.728596719260649E-03 0.000000000000000E+00 Lanczos iteration: 477 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000477)= 0.000000000000000E+00 beta (00000477)= 0.122933526326683E+02 gamma(00000477)= 0.122933526326683E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 478 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.2E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000478)= 0.000000000000000E+00 beta (00000478)= 0.135107050858892E+02 gamma(00000478)= 0.135107050858892E+02 z1= 1 0.596387277562835E-06 0.000000000000000E+00 z1= 2 0.155436274871450E-05 0.000000000000000E+00 z1= 3 -0.728515507846510E-03 0.000000000000000E+00 Lanczos iteration: 479 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000479)= 0.000000000000000E+00 beta (00000479)= 0.128237224915957E+02 gamma(00000479)= 0.128237224915957E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 480 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.9E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000480)= 0.000000000000000E+00 beta (00000480)= 0.133209143386192E+02 gamma(00000480)= 0.133209143386192E+02 z1= 1 -0.506802832121690E-06 0.000000000000000E+00 z1= 2 -0.164986702907272E-05 0.000000000000000E+00 z1= 3 0.755473053339308E-03 0.000000000000000E+00 Lanczos iteration: 481 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000481)= 0.000000000000000E+00 beta (00000481)= 0.130055357357648E+02 gamma(00000481)= 0.130055357357648E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 482 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000482)= 0.000000000000000E+00 beta (00000482)= 0.133048527651194E+02 gamma(00000482)= 0.133048527651194E+02 z1= 1 0.638463979953379E-06 0.000000000000000E+00 z1= 2 0.175486144002898E-05 0.000000000000000E+00 z1= 3 -0.803503115000433E-03 0.000000000000000E+00 Lanczos iteration: 483 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000483)= 0.000000000000000E+00 beta (00000483)= 0.122314439855613E+02 gamma(00000483)= 0.122314439855613E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 484 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.4E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000484)= 0.000000000000000E+00 beta (00000484)= 0.131720325336177E+02 gamma(00000484)= 0.131720325336177E+02 z1= 1 -0.576826265858538E-06 0.000000000000000E+00 z1= 2 -0.178918249875057E-05 0.000000000000000E+00 z1= 3 0.806538192839908E-03 0.000000000000000E+00 Lanczos iteration: 485 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000485)= 0.000000000000000E+00 beta (00000485)= 0.129964476202091E+02 gamma(00000485)= 0.129964476202091E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 486 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 8.9E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000486)= 0.000000000000000E+00 beta (00000486)= 0.131455933699598E+02 gamma(00000486)= 0.131455933699598E+02 z1= 1 0.676126801447941E-06 0.000000000000000E+00 z1= 2 0.192046824774601E-05 0.000000000000000E+00 z1= 3 -0.863102079988324E-03 0.000000000000000E+00 Lanczos iteration: 487 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000487)= 0.000000000000000E+00 beta (00000487)= 0.125242181996591E+02 gamma(00000487)= 0.125242181996591E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 488 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.7E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000488)= 0.000000000000000E+00 beta (00000488)= 0.137264483176475E+02 gamma(00000488)= 0.137264483176475E+02 z1= 1 -0.628533830846520E-06 0.000000000000000E+00 z1= 2 -0.190461416521635E-05 0.000000000000000E+00 z1= 3 0.846497684758057E-03 0.000000000000000E+00 Lanczos iteration: 489 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000489)= 0.000000000000000E+00 beta (00000489)= 0.130940861614278E+02 gamma(00000489)= 0.130940861614278E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 490 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000490)= 0.000000000000000E+00 beta (00000490)= 0.132923317248774E+02 gamma(00000490)= 0.132923317248774E+02 z1= 1 0.701478321806593E-06 0.000000000000000E+00 z1= 2 0.203446818973193E-05 0.000000000000000E+00 z1= 3 -0.896920738632976E-03 0.000000000000000E+00 Lanczos iteration: 491 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000491)= 0.000000000000000E+00 beta (00000491)= 0.122824544508681E+02 gamma(00000491)= 0.122824544508681E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 492 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 9.7E-13, # of iterations = 14 lr_apply_liouvillian: applying interaction: normal alpha(00000492)= 0.000000000000000E+00 beta (00000492)= 0.133117319250184E+02 gamma(00000492)= 0.133117319250184E+02 z1= 1 -0.690519209824571E-06 0.000000000000000E+00 z1= 2 -0.204562926476746E-05 0.000000000000000E+00 z1= 3 0.891394915019483E-03 0.000000000000000E+00 Lanczos iteration: 493 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000493)= 0.000000000000000E+00 beta (00000493)= 0.126686374903497E+02 gamma(00000493)= 0.126686374903497E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 494 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.0E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000494)= 0.000000000000000E+00 beta (00000494)= 0.134404943677006E+02 gamma(00000494)= 0.134404943677006E+02 z1= 1 0.710017819850100E-06 0.000000000000000E+00 z1= 2 0.209794503308082E-05 0.000000000000000E+00 z1= 3 -0.901480634863878E-03 0.000000000000000E+00 Lanczos iteration: 495 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000495)= 0.000000000000000E+00 beta (00000495)= 0.120544031337736E+02 gamma(00000495)= 0.120544031337736E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 496 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 4.8E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000496)= 0.000000000000000E+00 beta (00000496)= 0.133060771914048E+02 gamma(00000496)= 0.133060771914048E+02 z1= 1 -0.716756049475627E-06 0.000000000000000E+00 z1= 2 -0.208376885695938E-05 0.000000000000000E+00 z1= 3 0.887305679664198E-03 0.000000000000000E+00 Lanczos iteration: 497 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000497)= 0.000000000000000E+00 beta (00000497)= 0.123130460358137E+02 gamma(00000497)= 0.123130460358137E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 498 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 5.5E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000498)= 0.000000000000000E+00 beta (00000498)= 0.130343883243165E+02 gamma(00000498)= 0.130343883243165E+02 z1= 1 0.717658371808040E-06 0.000000000000000E+00 z1= 2 0.216563267687187E-05 0.000000000000000E+00 z1= 3 -0.904339356770052E-03 0.000000000000000E+00 Lanczos iteration: 499 Pol:3 lr_apply_liouvillian: not applying interaction alpha(00000499)= 0.000000000000000E+00 beta (00000499)= 0.127075485436516E+02 gamma(00000499)= 0.127075485436516E+02 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 Lanczos iteration: 500 Pol:3 ENVIRON: Calculate the response polarization and dielectric potentials polarization accuracy = 6.1E-13, # of iterations = 15 lr_apply_liouvillian: applying interaction: normal alpha(00000500)= 0.000000000000000E+00 beta (00000500)= 0.128240578000639E+02 gamma(00000500)= 0.128240578000639E+02 z1= 1 -0.826778906450076E-06 0.000000000000000E+00 z1= 2 -0.234098334834642E-05 0.000000000000000E+00 z1= 3 0.976208857518587E-03 0.000000000000000E+00 End of Lanczos iterations Finished linear response calculation... lr_main : 1138.40s CPU 1161.40s WALL ( 1 calls) read_wf : 0.03s CPU 0.07s WALL ( 1 calls) lr_solve_e : 1.21s CPU 1.41s WALL ( 1 calls) one_step : 1134.00s CPU 1155.63s WALL ( 1500 calls) lr_apply : 1131.76s CPU 1153.26s WALL ( 1500 calls) lr_apply_int : 1113.09s CPU 1134.09s WALL ( 750 calls) lr_apply_no : 18.67s CPU 19.17s WALL ( 750 calls) lr_apply : 1131.76s CPU 1153.26s WALL ( 1500 calls) h_psi : 36.86s CPU 37.69s WALL ( 1500 calls) lr_calc_dens : 14.15s CPU 14.42s WALL ( 750 calls) lr_ortho : 1.08s CPU 1.08s WALL ( 3000 calls) interaction : 10.08s CPU 10.29s WALL ( 750 calls) lr_dot : 0.48s CPU 0.51s WALL ( 3750 calls) lr_calc_dens : 14.15s CPU 14.42s WALL ( 750 calls) US routines lr_sm1_psi : 0.16s CPU 0.12s WALL ( 1500 calls) General routines calbec : 0.49s CPU 0.52s WALL ( 1608 calls) fft : 563.78s CPU 575.61s WALL ( 53559 calls) fftw : 42.70s CPU 43.60s WALL ( 9186 calls) interpolate : 0.48s CPU 0.52s WALL ( 750 calls) davcio : 0.00s CPU 0.00s WALL ( 49 calls) Parallel routines fft_scatter : 417.14s CPU 424.13s WALL ( 62745 calls) Environ routines calc_vsolv : 2.61s CPU 2.73s WALL ( 1 calls) dielectric : 0.16s CPU 0.18s WALL ( 1 calls) get_rhopol : 846.39s CPU 862.31s WALL ( 751 calls) calc_veps : 0.05s CPU 0.07s WALL ( 1 calls) calc_vsolven : 1042.94s CPU 1062.46s WALL ( 750 calls) EXX routines turboTDDFT : 18m58.41s CPU 19m21.48s WALL This run was terminated on: 18:42:47 8Feb2014 =------------------------------------------------------------------------------= JOB DONE. =------------------------------------------------------------------------------= TDDFPT/Examples/CH4-ENVIRON/CH4.tddfpt_pp-in0000644000175000017500000000025012341371500016256 0ustar mbamba&lr_input prefix='ch4', outdir='./out', itermax0=500 itermax=10000 extrapolation="osc" epsil=0.01 start=0.0d0 increment=0.001d0 end=3.50d0 ipol=4 / TDDFPT/Examples/CH4-ENVIRON/Makefile0000644000175000017500000000051312341371500015030 0ustar mbambainclude ../make.sys NAME = CH4 default : all all : check_results check_results: $(NAME).pw-out $(NAME).tddfpt-out $(NAME).tddfpt_pp-out $(check_pw) $(NAME).pw-out $(NAME).pw-ref $(check_tddfpt) $(NAME).tddfpt-out $(NAME).tddfpt-ref clean : - /bin/rm -rf $(NAME).pw-out $(NAME).tddfpt-out $(NAME).tddfpt_pp-out *.plot out/* TDDFPT/Examples/CH4/0000755000175000017500000000000012341371517012263 5ustar mbambaTDDFPT/Examples/CH4/CH4.tddfpt-in0000644000175000017500000000016312341371500014444 0ustar mbamba&lr_input prefix="ch4", outdir='./out', restart_step=250, / &lr_control itermax=500, ipol=4 / TDDFPT/Examples/CH4/CH4.tddfpt-st-in0000644000175000017500000000016112341371500015066 0ustar mbamba&lr_input prefix="ch4", outdir='./out', restart_step=250, / &lr_control itermax=5, ipol=1 / TDDFPT/Examples/CH4/CH4.pw-in0000644000175000017500000000123412341371500013605 0ustar mbamba&control calculation = 'scf' title = 'TDDFPT CH4 Test (Symmetry Enabled)' restart_mode='from_scratch', pseudo_dir = '../pseudo', outdir='./out', prefix='ch4' etot_conv_thr=1d-6 / &system ibrav = 1, celldm(1) = 30, nat = 5, ntyp = 2, ecutwfc = 25, / &electrons / &ions / ATOMIC_SPECIES C 1.0 C.pz-vbc.UPF H 1.0 H.pz-vbc.UPF ATOMIC_POSITIONS {Angstrom} C 0.000000000 0.000000000 0.000000000 H 0.642814093 0.642814093 0.642814093 H -0.642814093 -0.642814093 0.642814093 H 0.642814093 -0.642814093 -0.642814093 H -0.642814093 0.642814093 -0.642814093 K_POINTS {gamma} TDDFPT/Examples/CH4/CH4.pw-ref0000644000175000017500000002472212341371500013762 0ustar mbamba Program PWSCF v.4.99 starts on 12Jan2012 at 11:54: 0 This program is part of the open-source Quantum ESPRESSO suite for quantum simulation of materials; please cite "P. Giannozzi et al., J. Phys.:Condens. Matter 21 395502 (2009); URL http://www.quantum-espresso.org", in publications or presentations arising from this work. More details at http://www.quantum-espresso.org/quote.php Parallel version (MPI), running on 4 processors R & G space division: proc/pool = 4 Current dimensions of program PWSCF are: Max number of different atomic species (ntypx) = 10 Max number of k-points (npk) = 40000 Max angular momentum in pseudopotentials (lmaxx) = 3 Waiting for input... Reading input from stdin Warning: card &IONS ignored Warning: card / ignored file H.pz-vbc.UPF: wavefunction(s) 1S renormalized gamma-point specific algorithms are used Subspace diagonalization in iterative solution of the eigenvalue problem: a serial algorithm will be used Parallelization info -------------------- sticks: dense smooth PW G-vecs: dense smooth PW Min 1787 1787 445 113964 113964 14262 Max 1790 1790 450 113970 113970 14264 Sum 7153 7153 1789 455863 455863 57051 Tot 3577 3577 895 Title: TDDFPT CH4 Test (Symmetry Enabled) bravais-lattice index = 1 lattice parameter (alat) = 30.0000 a.u. unit-cell volume = 27000.0000 (a.u.)^3 number of atoms/cell = 5 number of atomic types = 2 number of electrons = 8.00 number of Kohn-Sham states= 4 kinetic-energy cutoff = 25.0000 Ry charge density cutoff = 100.0000 Ry convergence threshold = 1.0E-06 mixing beta = 0.7000 number of iterations used = 8 plain mixing Exchange-correlation = SLA PZ NOGX NOGC ( 1 1 0 0 0) EXX-fraction = 0.00 celldm(1)= 30.000000 celldm(2)= 0.000000 celldm(3)= 0.000000 celldm(4)= 0.000000 celldm(5)= 0.000000 celldm(6)= 0.000000 crystal axes: (cart. coord. in units of alat) a(1) = ( 1.000000 0.000000 0.000000 ) a(2) = ( 0.000000 1.000000 0.000000 ) a(3) = ( 0.000000 0.000000 1.000000 ) reciprocal axes: (cart. coord. in units 2 pi/alat) b(1) = ( 1.000000 0.000000 0.000000 ) b(2) = ( 0.000000 1.000000 0.000000 ) b(3) = ( 0.000000 0.000000 1.000000 ) PseudoPot. # 1 for C read from file: ../pseudo/C.pz-vbc.UPF MD5 check sum: ab53dd623bfeb79c5a7b057bc96eae20 Pseudo is Norm-conserving, Zval = 4.0 Generated by new atomic code, or converted to UPF format Using radial grid of 269 points, 1 beta functions with: l(1) = 0 PseudoPot. # 2 for H read from file: ../pseudo/H.pz-vbc.UPF MD5 check sum: 90becb985b714f09656c73597998d266 Pseudo is Norm-conserving, Zval = 1.0 Generated by new atomic code, or converted to UPF format Using radial grid of 131 points, 0 beta functions with: atomic species valence mass pseudopotential C 4.00 1.00000 C ( 1.00) H 1.00 1.00000 H ( 1.00) 24 Sym. Ops. (no inversion) found Cartesian axes site n. atom positions (alat units) 1 C tau( 1) = ( 0.0000000 0.0000000 0.0000000 ) 2 H tau( 2) = ( 0.0404914 0.0404914 0.0404914 ) 3 H tau( 3) = ( -0.0404914 -0.0404914 0.0404914 ) 4 H tau( 4) = ( 0.0404914 -0.0404914 -0.0404914 ) 5 H tau( 5) = ( -0.0404914 0.0404914 -0.0404914 ) number of k points= 1 cart. coord. in units 2pi/alat k( 1) = ( 0.0000000 0.0000000 0.0000000), wk = 2.0000000 Dense grid: 227932 G-vectors FFT dimensions: ( 96, 96, 96) Largest allocated arrays est. size (Mb) dimensions Kohn-Sham Wavefunctions 0.44 Mb ( 7131, 4) NL pseudopotentials 0.11 Mb ( 7131, 1) Each V/rho on FFT grid 3.38 Mb ( 221184) Each G-vector array 0.43 Mb ( 56985) G-vector shells 0.01 Mb ( 1880) Largest temporary arrays est. size (Mb) dimensions Auxiliary wavefunctions 0.87 Mb ( 7131, 16) Each subspace H/S matrix 0.00 Mb ( 16, 16) Each matrix 0.00 Mb ( 1, 4) Arrays for rho mixing 27.00 Mb ( 221184, 8) Initial potential from superposition of free atoms Check: negative starting charge= -0.039302 starting charge 7.99987, renormalised to 8.00000 negative rho (up, down): 0.393E-01 0.000E+00 Starting wfc are 8 randomized atomic wfcs total cpu time spent up to now is 0.6 secs per-process dynamical memory: 38.0 Mb Self-consistent Calculation iteration # 1 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 1.00E-02, avg # of iterations = 2.0 negative rho (up, down): 0.115E-01 0.000E+00 total cpu time spent up to now is 1.2 secs total energy = -15.61233185 Ry Harris-Foulkes estimate = -15.99153423 Ry estimated scf accuracy < 0.55766285 Ry iteration # 2 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 6.97E-03, avg # of iterations = 2.0 negative rho (up, down): 0.611E-02 0.000E+00 total cpu time spent up to now is 1.9 secs total energy = -15.73672521 Ry Harris-Foulkes estimate = -15.83980217 Ry estimated scf accuracy < 0.18859787 Ry iteration # 3 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 2.36E-03, avg # of iterations = 2.0 negative rho (up, down): 0.197E-03 0.000E+00 total cpu time spent up to now is 2.6 secs total energy = -15.77581324 Ry Harris-Foulkes estimate = -15.77833327 Ry estimated scf accuracy < 0.00500168 Ry iteration # 4 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 6.25E-05, avg # of iterations = 2.0 negative rho (up, down): 0.318E-03 0.000E+00 total cpu time spent up to now is 3.2 secs total energy = -15.77711037 Ry Harris-Foulkes estimate = -15.77736581 Ry estimated scf accuracy < 0.00055776 Ry iteration # 5 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 6.97E-06, avg # of iterations = 1.0 negative rho (up, down): 0.127E-04 0.000E+00 total cpu time spent up to now is 3.9 secs total energy = -15.77714180 Ry Harris-Foulkes estimate = -15.77714842 Ry estimated scf accuracy < 0.00001383 Ry iteration # 6 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 1.73E-07, avg # of iterations = 3.0 negative rho (up, down): 0.844E-07 0.000E+00 total cpu time spent up to now is 4.7 secs total energy = -15.77714616 Ry Harris-Foulkes estimate = -15.77714976 Ry estimated scf accuracy < 0.00000914 Ry iteration # 7 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 1.14E-07, avg # of iterations = 1.0 total cpu time spent up to now is 5.1 secs End of self-consistent calculation k = 0.0000 0.0000 0.0000 ( 28526 PWs) bands (ev): -16.9111 -9.3102 -9.3102 -9.3102 ! total energy = -15.77714666 Ry Harris-Foulkes estimate = -15.77714700 Ry estimated scf accuracy < 0.00000069 Ry The total energy is the sum of the following terms: one-electron contribution = -46.09971477 Ry hartree contribution = 23.71606951 Ry xc contribution = -6.06424978 Ry ewald contribution = 12.67074838 Ry convergence has been achieved in 7 iterations Writing output data file ch4.save init_run : 0.55s CPU 0.57s WALL ( 1 calls) electrons : 4.38s CPU 4.48s WALL ( 1 calls) Called by init_run: wfcinit : 0.18s CPU 0.18s WALL ( 1 calls) potinit : 0.18s CPU 0.18s WALL ( 1 calls) Called by electrons: c_bands : 1.86s CPU 1.87s WALL ( 7 calls) sum_band : 0.92s CPU 0.92s WALL ( 7 calls) v_of_rho : 0.53s CPU 0.54s WALL ( 8 calls) mix_rho : 0.51s CPU 0.52s WALL ( 7 calls) Called by c_bands: init_us_2 : 0.02s CPU 0.02s WALL ( 15 calls) regterg : 1.85s CPU 1.86s WALL ( 7 calls) Called by *egterg: h_psi : 1.92s CPU 1.92s WALL ( 21 calls) g_psi : 0.01s CPU 0.02s WALL ( 13 calls) rdiaghg : 0.01s CPU 0.00s WALL ( 20 calls) Called by h_psi: add_vuspsi : 0.01s CPU 0.01s WALL ( 21 calls) General routines calbec : 0.01s CPU 0.01s WALL ( 21 calls) fft : 1.07s CPU 1.08s WALL ( 31 calls) fftw : 1.87s CPU 1.88s WALL ( 102 calls) davcio : 0.00s CPU 0.00s WALL ( 7 calls) Parallel routines fft_scatter : 0.82s CPU 0.83s WALL ( 133 calls) PWSCF : 5.11s CPU 5.25s WALL This run was terminated on: 11:54: 6 12Jan2012 =------------------------------------------------------------------------------= JOB DONE. =------------------------------------------------------------------------------= TDDFPT/Examples/CH4/CH4.tddfpt-ref0000644000175000017500000247227212341371500014632 0ustar mbamba Program TDDFPT v.4.99 starts on 12Jan2012 at 12: 4:55 This program is part of the open-source Quantum ESPRESSO suite for quantum simulation of materials; please cite "P. Giannozzi et al., J. Phys.:Condens. Matter 21 395502 (2009); URL http://www.quantum-espresso.org", in publications or presentations arising from this work. More details at http://www.quantum-espresso.org/quote.php Parallel version (MPI), running on 4 processors R & G space division: proc/pool = 4 ---------------------------------------- This is TDDFPT (Time Dependent Density Functional Perturbation Theory) Sub Version: 0.9 ---------------------------------------- Ultrasoft (Vanderbilt) Pseudopotentials Info: using nr1, nr2, nr3 values from input Info: using nr1s, nr2s, nr3s values from input IMPORTANT: XC functional enforced from input : Exchange-correlation = SLA PZ NOGX NOGC ( 1 1 0 0 0) EXX-fraction = 0.00 Any further DFT definition will be discarded Please, verify this is what you really want file H.pz-vbc.UPF: wavefunction(s) 1S renormalized Parallelization info -------------------- sticks: dense smooth PW G-vecs: dense smooth PW Min 1787 1787 445 113964 113964 14262 Max 1790 1790 450 113970 113970 14264 Sum 7153 7153 1789 455863 455863 57051 Tot 3577 3577 895 Subspace diagonalization in iterative solution of the eigenvalue problem: a serial algorithm will be used Lanczos linear response spectrum calculation Number of Lanczos iterations = 500 Gamma point algorithm lr_wfcinit_spectrum: finished lr_solve_e Norm of initial Lanczos vectors= 1.841314958090108 Starting Lanczos loop 1 Lanczos iteration: 1 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal alpha(00000001)=0.000000000000000E+00 beta (00000002)=0.172013913000150E+01 gamma(00000002)=0.172013913000150E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 2 z1= 1 0.124507717706288E+01 0.000000000000000E+00 z1= 2 0.172110025483188E-06 0.000000000000000E+00 z1= 3 0.273451499546262E-06 0.000000000000000E+00 alpha(00000002)=0.000000000000000E+00 beta (00000003)=0.476624382768189E+01 gamma(00000003)=0.476624382768189E+01 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 3 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000003)=0.000000000000000E+00 beta (00000004)=0.135459644298635E+02 gamma(00000004)=0.135459644298635E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 4 z1= 1 -.355850969842812E+00 0.000000000000000E+00 z1= 2 -.533323382314460E-07 0.000000000000000E+00 z1= 3 -.830255178363307E-07 0.000000000000000E+00 alpha(00000004)=0.000000000000000E+00 beta (00000005)=0.127188556203638E+02 gamma(00000005)=0.127188556203638E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 5 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000005)=0.000000000000000E+00 beta (00000006)=0.134777630974300E+02 gamma(00000006)=0.134777630974300E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 6 z1= 1 0.303388656949718E+00 0.000000000000000E+00 z1= 2 0.488667713160681E-07 0.000000000000000E+00 z1= 3 0.789989796509899E-07 0.000000000000000E+00 alpha(00000006)=0.000000000000000E+00 beta (00000007)=0.128882495587011E+02 gamma(00000007)=0.128882495587011E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 7 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000007)=0.000000000000000E+00 beta (00000008)=0.133738534552992E+02 gamma(00000008)=0.133738534552992E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 8 z1= 1 -.273843898514234E+00 0.000000000000000E+00 z1= 2 -.457359434829704E-07 0.000000000000000E+00 z1= 3 -.797743010583804E-07 0.000000000000000E+00 alpha(00000008)=0.000000000000000E+00 beta (00000009)=0.128589246176755E+02 gamma(00000009)=0.128589246176755E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 9 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000009)=0.000000000000000E+00 beta (00000010)=0.134144085825355E+02 gamma(00000010)=0.134144085825355E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 10 z1= 1 0.250112033032304E+00 0.000000000000000E+00 z1= 2 0.447817948156680E-07 0.000000000000000E+00 z1= 3 0.800778492944607E-07 0.000000000000000E+00 alpha(00000010)=0.000000000000000E+00 beta (00000011)=0.128243168824828E+02 gamma(00000011)=0.128243168824828E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 11 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000011)=0.000000000000000E+00 beta (00000012)=0.134765055947239E+02 gamma(00000012)=0.134765055947239E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 12 z1= 1 -.228509358107091E+00 0.000000000000000E+00 z1= 2 -.480126108959398E-07 0.000000000000000E+00 z1= 3 -.817230677016079E-07 0.000000000000000E+00 alpha(00000012)=0.000000000000000E+00 beta (00000013)=0.128064933458035E+02 gamma(00000013)=0.128064933458035E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 13 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000013)=0.000000000000000E+00 beta (00000014)=0.134984080218229E+02 gamma(00000014)=0.134984080218229E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 14 z1= 1 0.209127940220470E+00 0.000000000000000E+00 z1= 2 0.526315810441425E-07 0.000000000000000E+00 z1= 3 0.872799397260912E-07 0.000000000000000E+00 alpha(00000014)=0.000000000000000E+00 beta (00000015)=0.128005632300634E+02 gamma(00000015)=0.128005632300634E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 15 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000015)=0.000000000000000E+00 beta (00000016)=0.134717443155172E+02 gamma(00000016)=0.134717443155172E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 16 z1= 1 -.192248806878382E+00 0.000000000000000E+00 z1= 2 -.628563475919049E-07 0.000000000000000E+00 z1= 3 -.963396090029140E-07 0.000000000000000E+00 alpha(00000016)=0.000000000000000E+00 beta (00000017)=0.127887247341979E+02 gamma(00000017)=0.127887247341979E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 17 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000017)=0.000000000000000E+00 beta (00000018)=0.134268154548181E+02 gamma(00000018)=0.134268154548181E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 18 z1= 1 0.177640819216545E+00 0.000000000000000E+00 z1= 2 0.746135324814108E-07 0.000000000000000E+00 z1= 3 0.107485554091784E-06 0.000000000000000E+00 alpha(00000018)=0.000000000000000E+00 beta (00000019)=0.127825853514745E+02 gamma(00000019)=0.127825853514745E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 19 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000019)=0.000000000000000E+00 beta (00000020)=0.134082301462394E+02 gamma(00000020)=0.134082301462394E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 20 z1= 1 -.164659663824982E+00 0.000000000000000E+00 z1= 2 -.868693625054318E-07 0.000000000000000E+00 z1= 3 -.117805890412453E-06 0.000000000000000E+00 alpha(00000020)=0.000000000000000E+00 beta (00000021)=0.128007452226864E+02 gamma(00000021)=0.128007452226864E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 21 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000021)=0.000000000000000E+00 beta (00000022)=0.134209328428411E+02 gamma(00000022)=0.134209328428411E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 22 z1= 1 0.153026546382725E+00 0.000000000000000E+00 z1= 2 0.100084135681335E-06 0.000000000000000E+00 z1= 3 0.122908110586155E-06 0.000000000000000E+00 alpha(00000022)=0.000000000000000E+00 beta (00000023)=0.128225911776854E+02 gamma(00000023)=0.128225911776854E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 23 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000023)=0.000000000000000E+00 beta (00000024)=0.134334871963251E+02 gamma(00000024)=0.134334871963251E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 24 z1= 1 -.142608232751349E+00 0.000000000000000E+00 z1= 2 -.112605803218382E-06 0.000000000000000E+00 z1= 3 -.132753756710712E-06 0.000000000000000E+00 alpha(00000024)=0.000000000000000E+00 beta (00000025)=0.128311476558543E+02 gamma(00000025)=0.128311476558543E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 25 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000025)=0.000000000000000E+00 beta (00000026)=0.134385686225742E+02 gamma(00000026)=0.134385686225742E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 26 z1= 1 0.133154034805725E+00 0.000000000000000E+00 z1= 2 0.120536931584418E-06 0.000000000000000E+00 z1= 3 0.141223354481446E-06 0.000000000000000E+00 alpha(00000026)=0.000000000000000E+00 beta (00000027)=0.128182408579081E+02 gamma(00000027)=0.128182408579081E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 27 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000027)=0.000000000000000E+00 beta (00000028)=0.134104219183791E+02 gamma(00000028)=0.134104219183791E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 28 z1= 1 -.124654437946127E+00 0.000000000000000E+00 z1= 2 -.132098332290571E-06 0.000000000000000E+00 z1= 3 -.145337760208697E-06 0.000000000000000E+00 alpha(00000028)=0.000000000000000E+00 beta (00000029)=0.127846971801688E+02 gamma(00000029)=0.127846971801688E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 29 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000029)=0.000000000000000E+00 beta (00000030)=0.134136261872629E+02 gamma(00000030)=0.134136261872629E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 30 z1= 1 0.116502181771159E+00 0.000000000000000E+00 z1= 2 0.142923686567622E-06 0.000000000000000E+00 z1= 3 0.150343344987834E-06 0.000000000000000E+00 alpha(00000030)=0.000000000000000E+00 beta (00000031)=0.128191852094781E+02 gamma(00000031)=0.128191852094781E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 31 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000031)=0.000000000000000E+00 beta (00000032)=0.134296073192580E+02 gamma(00000032)=0.134296073192580E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 32 z1= 1 -.109172784026460E+00 0.000000000000000E+00 z1= 2 -.148389954819465E-06 0.000000000000000E+00 z1= 3 -.155062509945626E-06 0.000000000000000E+00 alpha(00000032)=0.000000000000000E+00 beta (00000033)=0.127671482973640E+02 gamma(00000033)=0.127671482973640E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 33 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000033)=0.000000000000000E+00 beta (00000034)=0.133588559317082E+02 gamma(00000034)=0.133588559317082E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 34 z1= 1 0.102503222054251E+00 0.000000000000000E+00 z1= 2 0.153009215175630E-06 0.000000000000000E+00 z1= 3 0.156698193221191E-06 0.000000000000000E+00 alpha(00000034)=0.000000000000000E+00 beta (00000035)=0.127703449280494E+02 gamma(00000035)=0.127703449280494E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 35 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000035)=0.000000000000000E+00 beta (00000036)=0.134313015102964E+02 gamma(00000036)=0.134313015102964E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 36 z1= 1 -.958076985653707E-01 0.000000000000000E+00 z1= 2 -.152233170092400E-06 0.000000000000000E+00 z1= 3 -.154456084237582E-06 0.000000000000000E+00 alpha(00000036)=0.000000000000000E+00 beta (00000037)=0.128060724089533E+02 gamma(00000037)=0.128060724089533E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 37 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000037)=0.000000000000000E+00 beta (00000038)=0.133890906038219E+02 gamma(00000038)=0.133890906038219E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 38 z1= 1 0.901243785792502E-01 0.000000000000000E+00 z1= 2 0.148033492086870E-06 0.000000000000000E+00 z1= 3 0.152515650591678E-06 0.000000000000000E+00 alpha(00000038)=0.000000000000000E+00 beta (00000039)=0.127549834585508E+02 gamma(00000039)=0.127549834585508E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 39 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000039)=0.000000000000000E+00 beta (00000040)=0.133499005216435E+02 gamma(00000040)=0.133499005216435E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 40 z1= 1 -.847129717624768E-01 0.000000000000000E+00 z1= 2 -.141448503581873E-06 0.000000000000000E+00 z1= 3 -.150229744587480E-06 0.000000000000000E+00 alpha(00000040)=0.000000000000000E+00 beta (00000041)=0.126995597273433E+02 gamma(00000041)=0.126995597273433E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 41 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000041)=0.000000000000000E+00 beta (00000042)=0.133248691880123E+02 gamma(00000042)=0.133248691880123E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 42 z1= 1 0.794237070764004E-01 0.000000000000000E+00 z1= 2 0.137287306683533E-06 0.000000000000000E+00 z1= 3 0.149894172817890E-06 0.000000000000000E+00 alpha(00000042)=0.000000000000000E+00 beta (00000043)=0.127528770055346E+02 gamma(00000043)=0.127528770055346E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 43 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000043)=0.000000000000000E+00 beta (00000044)=0.133693946555481E+02 gamma(00000044)=0.133693946555481E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 44 z1= 1 -.745706855258888E-01 0.000000000000000E+00 z1= 2 -.138058874570371E-06 0.000000000000000E+00 z1= 3 -.149633980851176E-06 0.000000000000000E+00 alpha(00000044)=0.000000000000000E+00 beta (00000045)=0.127653088734531E+02 gamma(00000045)=0.127653088734531E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 45 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000045)=0.000000000000000E+00 beta (00000046)=0.134074086953825E+02 gamma(00000046)=0.134074086953825E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 46 z1= 1 0.698758663342498E-01 0.000000000000000E+00 z1= 2 0.137750422163525E-06 0.000000000000000E+00 z1= 3 0.149246918562922E-06 0.000000000000000E+00 alpha(00000046)=0.000000000000000E+00 beta (00000047)=0.127671429223596E+02 gamma(00000047)=0.127671429223596E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 47 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000047)=0.000000000000000E+00 beta (00000048)=0.133559386798317E+02 gamma(00000048)=0.133559386798317E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 48 z1= 1 -.657379319063197E-01 0.000000000000000E+00 z1= 2 -.134157082718085E-06 0.000000000000000E+00 z1= 3 -.153466451762114E-06 0.000000000000000E+00 alpha(00000048)=0.000000000000000E+00 beta (00000049)=0.128436480271743E+02 gamma(00000049)=0.128436480271743E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 49 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000049)=0.000000000000000E+00 beta (00000050)=0.134360455231597E+02 gamma(00000050)=0.134360455231597E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 50 z1= 1 0.618982711911030E-01 0.000000000000000E+00 z1= 2 0.127749750491665E-06 0.000000000000000E+00 z1= 3 0.156667361231452E-06 0.000000000000000E+00 alpha(00000050)=0.000000000000000E+00 beta (00000051)=0.126967708902151E+02 gamma(00000051)=0.126967708902151E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 51 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000051)=0.000000000000000E+00 beta (00000052)=0.132892764242009E+02 gamma(00000052)=0.132892764242009E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 52 z1= 1 -.582038952421809E-01 0.000000000000000E+00 z1= 2 -.123936754462504E-06 0.000000000000000E+00 z1= 3 -.158925837908394E-06 0.000000000000000E+00 alpha(00000052)=0.000000000000000E+00 beta (00000053)=0.127443746031057E+02 gamma(00000053)=0.127443746031057E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 53 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000053)=0.000000000000000E+00 beta (00000054)=0.133133397653751E+02 gamma(00000054)=0.133133397653751E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 54 z1= 1 0.548828460472523E-01 0.000000000000000E+00 z1= 2 0.119491190839552E-06 0.000000000000000E+00 z1= 3 0.160948815906403E-06 0.000000000000000E+00 alpha(00000054)=0.000000000000000E+00 beta (00000055)=0.127443754658804E+02 gamma(00000055)=0.127443754658804E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 55 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000055)=0.000000000000000E+00 beta (00000056)=0.133787252959899E+02 gamma(00000056)=0.133787252959899E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 56 z1= 1 -.515188266955839E-01 0.000000000000000E+00 z1= 2 -.111999312869121E-06 0.000000000000000E+00 z1= 3 -.165251772628458E-06 0.000000000000000E+00 alpha(00000056)=0.000000000000000E+00 beta (00000057)=0.128320491191718E+02 gamma(00000057)=0.128320491191718E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 57 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000057)=0.000000000000000E+00 beta (00000058)=0.134462097485749E+02 gamma(00000058)=0.134462097485749E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 58 z1= 1 0.484468061933174E-01 0.000000000000000E+00 z1= 2 0.104625899750334E-06 0.000000000000000E+00 z1= 3 0.167972815980685E-06 0.000000000000000E+00 alpha(00000058)=0.000000000000000E+00 beta (00000059)=0.127464627477991E+02 gamma(00000059)=0.127464627477991E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 59 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000059)=0.000000000000000E+00 beta (00000060)=0.133329424652152E+02 gamma(00000060)=0.133329424652152E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 60 z1= 1 -.456811892089485E-01 0.000000000000000E+00 z1= 2 -.102671083020839E-06 0.000000000000000E+00 z1= 3 -.167677891309411E-06 0.000000000000000E+00 alpha(00000060)=0.000000000000000E+00 beta (00000061)=0.128406170552953E+02 gamma(00000061)=0.128406170552953E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 61 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000061)=0.000000000000000E+00 beta (00000062)=0.133762266343913E+02 gamma(00000062)=0.133762266343913E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 62 z1= 1 0.432498219601232E-01 0.000000000000000E+00 z1= 2 0.102290785028089E-06 0.000000000000000E+00 z1= 3 0.169113527550809E-06 0.000000000000000E+00 alpha(00000062)=0.000000000000000E+00 beta (00000063)=0.128441567607503E+02 gamma(00000063)=0.128441567607503E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 63 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000063)=0.000000000000000E+00 beta (00000064)=0.134461690790506E+02 gamma(00000064)=0.134461690790506E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 64 z1= 1 -.407854095427376E-01 0.000000000000000E+00 z1= 2 -.101764390188913E-06 0.000000000000000E+00 z1= 3 -.171761094363730E-06 0.000000000000000E+00 alpha(00000064)=0.000000000000000E+00 beta (00000065)=0.128237830923699E+02 gamma(00000065)=0.128237830923699E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 65 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000065)=0.000000000000000E+00 beta (00000066)=0.134806315309632E+02 gamma(00000066)=0.134806315309632E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 66 z1= 1 0.383379511327743E-01 0.000000000000000E+00 z1= 2 0.940090968465021E-07 0.000000000000000E+00 z1= 3 0.172145202521337E-06 0.000000000000000E+00 alpha(00000066)=0.000000000000000E+00 beta (00000067)=0.128621507053119E+02 gamma(00000067)=0.128621507053119E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 67 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000067)=0.000000000000000E+00 beta (00000068)=0.133883491630513E+02 gamma(00000068)=0.133883491630513E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 68 z1= 1 -.363901040484774E-01 0.000000000000000E+00 z1= 2 -.847596342964593E-07 0.000000000000000E+00 z1= 3 -.171928287430846E-06 0.000000000000000E+00 alpha(00000068)=0.000000000000000E+00 beta (00000069)=0.128153635558545E+02 gamma(00000069)=0.128153635558545E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 69 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000069)=0.000000000000000E+00 beta (00000070)=0.133446923669071E+02 gamma(00000070)=0.133446923669071E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 70 z1= 1 0.345608950804169E-01 0.000000000000000E+00 z1= 2 0.783058450044144E-07 0.000000000000000E+00 z1= 3 0.167135372843063E-06 0.000000000000000E+00 alpha(00000070)=0.000000000000000E+00 beta (00000071)=0.128069911381342E+02 gamma(00000071)=0.128069911381342E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 71 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000071)=0.000000000000000E+00 beta (00000072)=0.134044182944087E+02 gamma(00000072)=0.134044182944087E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 72 z1= 1 -.326774386612864E-01 0.000000000000000E+00 z1= 2 -.746946227461222E-07 0.000000000000000E+00 z1= 3 -.161412696022363E-06 0.000000000000000E+00 alpha(00000072)=0.000000000000000E+00 beta (00000073)=0.128627071292028E+02 gamma(00000073)=0.128627071292028E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 73 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000073)=0.000000000000000E+00 beta (00000074)=0.133233011371570E+02 gamma(00000074)=0.133233011371570E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 74 z1= 1 0.312847571257820E-01 0.000000000000000E+00 z1= 2 0.727334662203177E-07 0.000000000000000E+00 z1= 3 0.161515136598567E-06 0.000000000000000E+00 alpha(00000074)=0.000000000000000E+00 beta (00000075)=0.127141545766000E+02 gamma(00000075)=0.127141545766000E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 75 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000075)=0.000000000000000E+00 beta (00000076)=0.133871085930435E+02 gamma(00000076)=0.133871085930435E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 76 z1= 1 -.294455229213025E-01 0.000000000000000E+00 z1= 2 -.705193352055003E-07 0.000000000000000E+00 z1= 3 -.159632178948089E-06 0.000000000000000E+00 alpha(00000076)=0.000000000000000E+00 beta (00000077)=0.127642051352244E+02 gamma(00000077)=0.127642051352244E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 77 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000077)=0.000000000000000E+00 beta (00000078)=0.133756591587483E+02 gamma(00000078)=0.133756591587483E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 78 z1= 1 0.278573754384349E-01 0.000000000000000E+00 z1= 2 0.681939818169240E-07 0.000000000000000E+00 z1= 3 0.161563907779020E-06 0.000000000000000E+00 alpha(00000078)=0.000000000000000E+00 beta (00000079)=0.128263636987873E+02 gamma(00000079)=0.128263636987873E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 79 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000079)=0.000000000000000E+00 beta (00000080)=0.133318286241464E+02 gamma(00000080)=0.133318286241464E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 80 z1= 1 -.266394765777384E-01 0.000000000000000E+00 z1= 2 -.687548181257415E-07 0.000000000000000E+00 z1= 3 -.164215252649886E-06 0.000000000000000E+00 alpha(00000080)=0.000000000000000E+00 beta (00000081)=0.127857472022911E+02 gamma(00000081)=0.127857472022911E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 81 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000081)=0.000000000000000E+00 beta (00000082)=0.133996448157895E+02 gamma(00000082)=0.133996448157895E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 82 z1= 1 0.252906631447164E-01 0.000000000000000E+00 z1= 2 0.699487623309625E-07 0.000000000000000E+00 z1= 3 0.163526531808894E-06 0.000000000000000E+00 alpha(00000082)=0.000000000000000E+00 beta (00000083)=0.128397177590354E+02 gamma(00000083)=0.128397177590354E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 83 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000083)=0.000000000000000E+00 beta (00000084)=0.133719718778360E+02 gamma(00000084)=0.133719718778360E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 84 z1= 1 -.241577981410933E-01 0.000000000000000E+00 z1= 2 -.695187752793557E-07 0.000000000000000E+00 z1= 3 -.168238635228374E-06 0.000000000000000E+00 alpha(00000084)=0.000000000000000E+00 beta (00000085)=0.128118031204495E+02 gamma(00000085)=0.128118031204495E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 85 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000085)=0.000000000000000E+00 beta (00000086)=0.133220375809574E+02 gamma(00000086)=0.133220375809574E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 86 z1= 1 0.231342748080053E-01 0.000000000000000E+00 z1= 2 0.724825576252017E-07 0.000000000000000E+00 z1= 3 0.173697869814901E-06 0.000000000000000E+00 alpha(00000086)=0.000000000000000E+00 beta (00000087)=0.127545618761112E+02 gamma(00000087)=0.127545618761112E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 87 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000087)=0.000000000000000E+00 beta (00000088)=0.133437918229343E+02 gamma(00000088)=0.133437918229343E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 88 z1= 1 -.220399068884482E-01 0.000000000000000E+00 z1= 2 -.771318074445360E-07 0.000000000000000E+00 z1= 3 -.175828176414861E-06 0.000000000000000E+00 alpha(00000088)=0.000000000000000E+00 beta (00000089)=0.128929330332062E+02 gamma(00000089)=0.128929330332062E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 89 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000089)=0.000000000000000E+00 beta (00000090)=0.133926942874537E+02 gamma(00000090)=0.133926942874537E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 90 z1= 1 0.211691265344259E-01 0.000000000000000E+00 z1= 2 0.846086583789277E-07 0.000000000000000E+00 z1= 3 0.178958627151276E-06 0.000000000000000E+00 alpha(00000090)=0.000000000000000E+00 beta (00000091)=0.126659770987958E+02 gamma(00000091)=0.126659770987958E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 91 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000091)=0.000000000000000E+00 beta (00000092)=0.133460213960076E+02 gamma(00000092)=0.133460213960076E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 92 z1= 1 -.200728187922513E-01 0.000000000000000E+00 z1= 2 -.913243675547577E-07 0.000000000000000E+00 z1= 3 -.180021071115245E-06 0.000000000000000E+00 alpha(00000092)=0.000000000000000E+00 beta (00000093)=0.127909478433986E+02 gamma(00000093)=0.127909478433986E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 93 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000093)=0.000000000000000E+00 beta (00000094)=0.133463364510848E+02 gamma(00000094)=0.133463364510848E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 94 z1= 1 0.192658530238279E-01 0.000000000000000E+00 z1= 2 0.883461514955726E-07 0.000000000000000E+00 z1= 3 0.185602906601474E-06 0.000000000000000E+00 alpha(00000094)=0.000000000000000E+00 beta (00000095)=0.127865902243021E+02 gamma(00000095)=0.127865902243021E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 95 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000095)=0.000000000000000E+00 beta (00000096)=0.133903068076643E+02 gamma(00000096)=0.133903068076643E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 96 z1= 1 -.184042938030230E-01 0.000000000000000E+00 z1= 2 -.790005275077763E-07 0.000000000000000E+00 z1= 3 -.188459504293372E-06 0.000000000000000E+00 alpha(00000096)=0.000000000000000E+00 beta (00000097)=0.127921102875331E+02 gamma(00000097)=0.127921102875331E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 97 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000097)=0.000000000000000E+00 beta (00000098)=0.134511215518528E+02 gamma(00000098)=0.134511215518528E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 98 z1= 1 0.174969196332044E-01 0.000000000000000E+00 z1= 2 0.704131364707983E-07 0.000000000000000E+00 z1= 3 0.193055205139833E-06 0.000000000000000E+00 alpha(00000098)=0.000000000000000E+00 beta (00000099)=0.130150114487129E+02 gamma(00000099)=0.130150114487129E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 99 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000099)=0.000000000000000E+00 beta (00000100)=0.136151550261075E+02 gamma(00000100)=0.136151550261075E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 100 z1= 1 -.167427680054819E-01 0.000000000000000E+00 z1= 2 -.602212666795353E-07 0.000000000000000E+00 z1= 3 -.196573477073496E-06 0.000000000000000E+00 alpha(00000100)=0.000000000000000E+00 beta (00000101)=0.127970449708917E+02 gamma(00000101)=0.127970449708917E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 101 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000101)=0.000000000000000E+00 beta (00000102)=0.132883959007072E+02 gamma(00000102)=0.132883959007072E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 102 z1= 1 0.161683674786537E-01 0.000000000000000E+00 z1= 2 0.543253321680891E-07 0.000000000000000E+00 z1= 3 0.198575617433520E-06 0.000000000000000E+00 alpha(00000102)=0.000000000000000E+00 beta (00000103)=0.128815585279153E+02 gamma(00000103)=0.128815585279153E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 103 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000103)=0.000000000000000E+00 beta (00000104)=0.134149795832625E+02 gamma(00000104)=0.134149795832625E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 104 z1= 1 -.156162321488891E-01 0.000000000000000E+00 z1= 2 -.552858120041622E-07 0.000000000000000E+00 z1= 3 -.199130863041855E-06 0.000000000000000E+00 alpha(00000104)=0.000000000000000E+00 beta (00000105)=0.128779017246173E+02 gamma(00000105)=0.128779017246173E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 105 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000105)=0.000000000000000E+00 beta (00000106)=0.132661755189466E+02 gamma(00000106)=0.132661755189466E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 106 z1= 1 0.152608699360563E-01 0.000000000000000E+00 z1= 2 0.608581015996198E-07 0.000000000000000E+00 z1= 3 0.198220570175772E-06 0.000000000000000E+00 alpha(00000106)=0.000000000000000E+00 beta (00000107)=0.126949041230652E+02 gamma(00000107)=0.126949041230652E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 107 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000107)=0.000000000000000E+00 beta (00000108)=0.133397974466831E+02 gamma(00000108)=0.133397974466831E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 108 z1= 1 -.145791472028309E-01 0.000000000000000E+00 z1= 2 -.689650859534135E-07 0.000000000000000E+00 z1= 3 -.194105460732586E-06 0.000000000000000E+00 alpha(00000108)=0.000000000000000E+00 beta (00000109)=0.128482327192284E+02 gamma(00000109)=0.128482327192284E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 109 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000109)=0.000000000000000E+00 beta (00000110)=0.133221252226615E+02 gamma(00000110)=0.133221252226615E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 110 z1= 1 0.141136286201870E-01 0.000000000000000E+00 z1= 2 0.748437499603887E-07 0.000000000000000E+00 z1= 3 0.194358802038609E-06 0.000000000000000E+00 alpha(00000110)=0.000000000000000E+00 beta (00000111)=0.126966177118998E+02 gamma(00000111)=0.126966177118998E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 111 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000111)=0.000000000000000E+00 beta (00000112)=0.135208591239886E+02 gamma(00000112)=0.135208591239886E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 112 z1= 1 -.133122721388112E-01 0.000000000000000E+00 z1= 2 -.751988463225340E-07 0.000000000000000E+00 z1= 3 -.188290668274964E-06 0.000000000000000E+00 alpha(00000112)=0.000000000000000E+00 beta (00000113)=0.129787366172340E+02 gamma(00000113)=0.129787366172340E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 113 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000113)=0.000000000000000E+00 beta (00000114)=0.134375146420441E+02 gamma(00000114)=0.134375146420441E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 114 z1= 1 0.128906018814572E-01 0.000000000000000E+00 z1= 2 0.764346034995140E-07 0.000000000000000E+00 z1= 3 0.190137899157327E-06 0.000000000000000E+00 alpha(00000114)=0.000000000000000E+00 beta (00000115)=0.127032864687937E+02 gamma(00000115)=0.127032864687937E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 115 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000115)=0.000000000000000E+00 beta (00000116)=0.135071532659700E+02 gamma(00000116)=0.135071532659700E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 116 z1= 1 -.122054676793222E-01 0.000000000000000E+00 z1= 2 -.783683625730103E-07 0.000000000000000E+00 z1= 3 -.189857389388376E-06 0.000000000000000E+00 alpha(00000116)=0.000000000000000E+00 beta (00000117)=0.127084746553192E+02 gamma(00000117)=0.127084746553192E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 117 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000117)=0.000000000000000E+00 beta (00000118)=0.132508093093342E+02 gamma(00000118)=0.132508093093342E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 118 z1= 1 0.118201577525991E-01 0.000000000000000E+00 z1= 2 0.791930573412151E-07 0.000000000000000E+00 z1= 3 0.191577596385080E-06 0.000000000000000E+00 alpha(00000118)=0.000000000000000E+00 beta (00000119)=0.127948192880293E+02 gamma(00000119)=0.127948192880293E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 119 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000119)=0.000000000000000E+00 beta (00000120)=0.133201070840169E+02 gamma(00000120)=0.133201070840169E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 120 z1= 1 -.114520838604654E-01 0.000000000000000E+00 z1= 2 -.777753082501290E-07 0.000000000000000E+00 z1= 3 -.191179009622093E-06 0.000000000000000E+00 alpha(00000120)=0.000000000000000E+00 beta (00000121)=0.125251298184348E+02 gamma(00000121)=0.125251298184348E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 121 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000121)=0.000000000000000E+00 beta (00000122)=0.131932748754092E+02 gamma(00000122)=0.131932748754092E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 122 z1= 1 0.109776565640075E-01 0.000000000000000E+00 z1= 2 0.743743375658003E-07 0.000000000000000E+00 z1= 3 0.185342220513848E-06 0.000000000000000E+00 alpha(00000122)=0.000000000000000E+00 beta (00000123)=0.127052683839714E+02 gamma(00000123)=0.127052683839714E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 123 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000123)=0.000000000000000E+00 beta (00000124)=0.133822013165842E+02 gamma(00000124)=0.133822013165842E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 124 z1= 1 -.104974416390519E-01 0.000000000000000E+00 z1= 2 -.683595499169527E-07 0.000000000000000E+00 z1= 3 -.179908110047554E-06 0.000000000000000E+00 alpha(00000124)=0.000000000000000E+00 beta (00000125)=0.126842722748912E+02 gamma(00000125)=0.126842722748912E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 125 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000125)=0.000000000000000E+00 beta (00000126)=0.133806504161737E+02 gamma(00000126)=0.133806504161737E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 126 z1= 1 0.100322717945944E-01 0.000000000000000E+00 z1= 2 0.650107041312055E-07 0.000000000000000E+00 z1= 3 0.179941089499189E-06 0.000000000000000E+00 alpha(00000126)=0.000000000000000E+00 beta (00000127)=0.128062267736613E+02 gamma(00000127)=0.128062267736613E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 127 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000127)=0.000000000000000E+00 beta (00000128)=0.132909495466963E+02 gamma(00000128)=0.132909495466963E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 128 z1= 1 -.972832197257753E-02 0.000000000000000E+00 z1= 2 -.609148036378668E-07 0.000000000000000E+00 z1= 3 -.187634556170213E-06 0.000000000000000E+00 alpha(00000128)=0.000000000000000E+00 beta (00000129)=0.127748180983853E+02 gamma(00000129)=0.127748180983853E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 129 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000129)=0.000000000000000E+00 beta (00000130)=0.132952919980961E+02 gamma(00000130)=0.132952919980961E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 130 z1= 1 0.940652787409279E-02 0.000000000000000E+00 z1= 2 0.629664988413547E-07 0.000000000000000E+00 z1= 3 0.195572903749540E-06 0.000000000000000E+00 alpha(00000130)=0.000000000000000E+00 beta (00000131)=0.127447084353176E+02 gamma(00000131)=0.127447084353176E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 131 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000131)=0.000000000000000E+00 beta (00000132)=0.131435719664986E+02 gamma(00000132)=0.131435719664986E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 132 z1= 1 -.917005719590564E-02 0.000000000000000E+00 z1= 2 -.657391705074020E-07 0.000000000000000E+00 z1= 3 -.205504634042102E-06 0.000000000000000E+00 alpha(00000132)=0.000000000000000E+00 beta (00000133)=0.127574462509418E+02 gamma(00000133)=0.127574462509418E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 133 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000133)=0.000000000000000E+00 beta (00000134)=0.134673006540469E+02 gamma(00000134)=0.134673006540469E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 134 z1= 1 0.868565104701532E-02 0.000000000000000E+00 z1= 2 0.645509204586989E-07 0.000000000000000E+00 z1= 3 0.204699769688877E-06 0.000000000000000E+00 alpha(00000134)=0.000000000000000E+00 beta (00000135)=0.127762524835563E+02 gamma(00000135)=0.127762524835563E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 135 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000135)=0.000000000000000E+00 beta (00000136)=0.134261521411496E+02 gamma(00000136)=0.134261521411496E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 136 z1= 1 -.829561708289547E-02 0.000000000000000E+00 z1= 2 -.637576063632940E-07 0.000000000000000E+00 z1= 3 -.204079060909038E-06 0.000000000000000E+00 alpha(00000136)=0.000000000000000E+00 beta (00000137)=0.129114146535843E+02 gamma(00000137)=0.129114146535843E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 137 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000137)=0.000000000000000E+00 beta (00000138)=0.133838995525524E+02 gamma(00000138)=0.133838995525524E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 138 z1= 1 0.808331883099109E-02 0.000000000000000E+00 z1= 2 0.620803879180024E-07 0.000000000000000E+00 z1= 3 0.202101489872966E-06 0.000000000000000E+00 alpha(00000138)=0.000000000000000E+00 beta (00000139)=0.129443559092156E+02 gamma(00000139)=0.129443559092156E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 139 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000139)=0.000000000000000E+00 beta (00000140)=0.135474786353335E+02 gamma(00000140)=0.135474786353335E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 140 z1= 1 -.781484921836521E-02 0.000000000000000E+00 z1= 2 -.574011125343849E-07 0.000000000000000E+00 z1= 3 -.194567971480196E-06 0.000000000000000E+00 alpha(00000140)=0.000000000000000E+00 beta (00000141)=0.127277868692279E+02 gamma(00000141)=0.127277868692279E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 141 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000141)=0.000000000000000E+00 beta (00000142)=0.134911104253645E+02 gamma(00000142)=0.134911104253645E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 142 z1= 1 0.746543569462110E-02 0.000000000000000E+00 z1= 2 0.553492011507416E-07 0.000000000000000E+00 z1= 3 0.181900565104833E-06 0.000000000000000E+00 alpha(00000142)=0.000000000000000E+00 beta (00000143)=0.127389223506633E+02 gamma(00000143)=0.127389223506633E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 143 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000143)=0.000000000000000E+00 beta (00000144)=0.134411298894579E+02 gamma(00000144)=0.134411298894579E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 144 z1= 1 -.714304458656644E-02 0.000000000000000E+00 z1= 2 -.562626079948260E-07 0.000000000000000E+00 z1= 3 -.173940105183601E-06 0.000000000000000E+00 alpha(00000144)=0.000000000000000E+00 beta (00000145)=0.129263303227384E+02 gamma(00000145)=0.129263303227384E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 145 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000145)=0.000000000000000E+00 beta (00000146)=0.133959100264201E+02 gamma(00000146)=0.133959100264201E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 146 z1= 1 0.694247458193422E-02 0.000000000000000E+00 z1= 2 0.589249181757318E-07 0.000000000000000E+00 z1= 3 0.173046877995856E-06 0.000000000000000E+00 alpha(00000146)=0.000000000000000E+00 beta (00000147)=0.128292395850084E+02 gamma(00000147)=0.128292395850084E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 147 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000147)=0.000000000000000E+00 beta (00000148)=0.136378997845373E+02 gamma(00000148)=0.136378997845373E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 148 z1= 1 -.656290164959142E-02 0.000000000000000E+00 z1= 2 -.586641496326881E-07 0.000000000000000E+00 z1= 3 -.170288383284721E-06 0.000000000000000E+00 alpha(00000148)=0.000000000000000E+00 beta (00000149)=0.127202835160260E+02 gamma(00000149)=0.127202835160260E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 149 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000149)=0.000000000000000E+00 beta (00000150)=0.135409244595745E+02 gamma(00000150)=0.135409244595745E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 150 z1= 1 0.617488174940836E-02 0.000000000000000E+00 z1= 2 0.578877077965154E-07 0.000000000000000E+00 z1= 3 0.163038861171949E-06 0.000000000000000E+00 alpha(00000150)=0.000000000000000E+00 beta (00000151)=0.126679658470695E+02 gamma(00000151)=0.126679658470695E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 151 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000151)=0.000000000000000E+00 beta (00000152)=0.134959022484013E+02 gamma(00000152)=0.134959022484013E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 152 z1= 1 -.579245465348682E-02 0.000000000000000E+00 z1= 2 -.579168597664159E-07 0.000000000000000E+00 z1= 3 -.155199720840290E-06 0.000000000000000E+00 alpha(00000152)=0.000000000000000E+00 beta (00000153)=0.125474375194310E+02 gamma(00000153)=0.125474375194310E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 153 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000153)=0.000000000000000E+00 beta (00000154)=0.132884237834285E+02 gamma(00000154)=0.132884237834285E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 154 z1= 1 0.544620305859431E-02 0.000000000000000E+00 z1= 2 0.568771318155449E-07 0.000000000000000E+00 z1= 3 0.149879989708287E-06 0.000000000000000E+00 alpha(00000154)=0.000000000000000E+00 beta (00000155)=0.128414506125377E+02 gamma(00000155)=0.128414506125377E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 155 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000155)=0.000000000000000E+00 beta (00000156)=0.133881967733065E+02 gamma(00000156)=0.133881967733065E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 156 z1= 1 -.518393078165251E-02 0.000000000000000E+00 z1= 2 -.506823511815541E-07 0.000000000000000E+00 z1= 3 -.144829972600240E-06 0.000000000000000E+00 alpha(00000156)=0.000000000000000E+00 beta (00000157)=0.128085736595203E+02 gamma(00000157)=0.128085736595203E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 157 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000157)=0.000000000000000E+00 beta (00000158)=0.135345778649926E+02 gamma(00000158)=0.135345778649926E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 158 z1= 1 0.481534906680857E-02 0.000000000000000E+00 z1= 2 0.453463547401937E-07 0.000000000000000E+00 z1= 3 0.136781640881984E-06 0.000000000000000E+00 alpha(00000158)=0.000000000000000E+00 beta (00000159)=0.127048635061392E+02 gamma(00000159)=0.127048635061392E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 159 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000159)=0.000000000000000E+00 beta (00000160)=0.132661189739892E+02 gamma(00000160)=0.132661189739892E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 160 z1= 1 -.451286898741119E-02 0.000000000000000E+00 z1= 2 -.388496398825945E-07 0.000000000000000E+00 z1= 3 -.134656891743714E-06 0.000000000000000E+00 alpha(00000160)=0.000000000000000E+00 beta (00000161)=0.125636007184791E+02 gamma(00000161)=0.125636007184791E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 161 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000161)=0.000000000000000E+00 beta (00000162)=0.133040218559196E+02 gamma(00000162)=0.133040218559196E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 162 z1= 1 0.422478231850923E-02 0.000000000000000E+00 z1= 2 0.368639357199718E-07 0.000000000000000E+00 z1= 3 0.135268325007895E-06 0.000000000000000E+00 alpha(00000162)=0.000000000000000E+00 beta (00000163)=0.127496114503810E+02 gamma(00000163)=0.127496114503810E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 163 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000163)=0.000000000000000E+00 beta (00000164)=0.131754002035538E+02 gamma(00000164)=0.131754002035538E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 164 z1= 1 -.410525774345625E-02 0.000000000000000E+00 z1= 2 -.379475563114500E-07 0.000000000000000E+00 z1= 3 -.132326088241145E-06 0.000000000000000E+00 alpha(00000164)=0.000000000000000E+00 beta (00000165)=0.126037215302878E+02 gamma(00000165)=0.126037215302878E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 165 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000165)=0.000000000000000E+00 beta (00000166)=0.134361134345366E+02 gamma(00000166)=0.134361134345366E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 166 z1= 1 0.389268523939014E-02 0.000000000000000E+00 z1= 2 0.319646180969337E-07 0.000000000000000E+00 z1= 3 0.125055969301096E-06 0.000000000000000E+00 alpha(00000166)=0.000000000000000E+00 beta (00000167)=0.127184991952864E+02 gamma(00000167)=0.127184991952864E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 167 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000167)=0.000000000000000E+00 beta (00000168)=0.134467296133425E+02 gamma(00000168)=0.134467296133425E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 168 z1= 1 -.378944521791291E-02 0.000000000000000E+00 z1= 2 -.258893836854734E-07 0.000000000000000E+00 z1= 3 -.123370995477542E-06 0.000000000000000E+00 alpha(00000168)=0.000000000000000E+00 beta (00000169)=0.127725687538598E+02 gamma(00000169)=0.127725687538598E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 169 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000169)=0.000000000000000E+00 beta (00000170)=0.132924807121830E+02 gamma(00000170)=0.132924807121830E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 170 z1= 1 0.374997396467056E-02 0.000000000000000E+00 z1= 2 0.267852645144135E-07 0.000000000000000E+00 z1= 3 0.123356743837093E-06 0.000000000000000E+00 alpha(00000170)=0.000000000000000E+00 beta (00000171)=0.127568410962278E+02 gamma(00000171)=0.127568410962278E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 171 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000171)=0.000000000000000E+00 beta (00000172)=0.133684000950250E+02 gamma(00000172)=0.133684000950250E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 172 z1= 1 -.370823073662980E-02 0.000000000000000E+00 z1= 2 -.280928323871839E-07 0.000000000000000E+00 z1= 3 -.121942185977899E-06 0.000000000000000E+00 alpha(00000172)=0.000000000000000E+00 beta (00000173)=0.127959846110715E+02 gamma(00000173)=0.127959846110715E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 173 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000173)=0.000000000000000E+00 beta (00000174)=0.134744090538998E+02 gamma(00000174)=0.134744090538998E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 174 z1= 1 0.356663019304626E-02 0.000000000000000E+00 z1= 2 0.317533262821600E-07 0.000000000000000E+00 z1= 3 0.123114734604615E-06 0.000000000000000E+00 alpha(00000174)=0.000000000000000E+00 beta (00000175)=0.128361285336717E+02 gamma(00000175)=0.128361285336717E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 175 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000175)=0.000000000000000E+00 beta (00000176)=0.133958459355916E+02 gamma(00000176)=0.133958459355916E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 176 z1= 1 -.335056019886754E-02 0.000000000000000E+00 z1= 2 -.352155964918402E-07 0.000000000000000E+00 z1= 3 -.122894473858232E-06 0.000000000000000E+00 alpha(00000176)=0.000000000000000E+00 beta (00000177)=0.127371036374703E+02 gamma(00000177)=0.127371036374703E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 177 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000177)=0.000000000000000E+00 beta (00000178)=0.133612403279400E+02 gamma(00000178)=0.133612403279400E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 178 z1= 1 0.311755801015426E-02 0.000000000000000E+00 z1= 2 0.343388927674659E-07 0.000000000000000E+00 z1= 3 0.121338890377953E-06 0.000000000000000E+00 alpha(00000178)=0.000000000000000E+00 beta (00000179)=0.126228386619202E+02 gamma(00000179)=0.126228386619202E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 179 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000179)=0.000000000000000E+00 beta (00000180)=0.134190343723186E+02 gamma(00000180)=0.134190343723186E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 180 z1= 1 -.280068527273373E-02 0.000000000000000E+00 z1= 2 -.312829932372968E-07 0.000000000000000E+00 z1= 3 -.114612028976333E-06 0.000000000000000E+00 alpha(00000180)=0.000000000000000E+00 beta (00000181)=0.127642870678688E+02 gamma(00000181)=0.127642870678688E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 181 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000181)=0.000000000000000E+00 beta (00000182)=0.134410605036134E+02 gamma(00000182)=0.134410605036134E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 182 z1= 1 0.252339530358128E-02 0.000000000000000E+00 z1= 2 0.264369449086161E-07 0.000000000000000E+00 z1= 3 0.109268982046524E-06 0.000000000000000E+00 alpha(00000182)=0.000000000000000E+00 beta (00000183)=0.128179278325257E+02 gamma(00000183)=0.128179278325257E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 183 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000183)=0.000000000000000E+00 beta (00000184)=0.135091025110373E+02 gamma(00000184)=0.135091025110373E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 184 z1= 1 -.228736214363473E-02 0.000000000000000E+00 z1= 2 -.221449108925515E-07 0.000000000000000E+00 z1= 3 -.105846812753572E-06 0.000000000000000E+00 alpha(00000184)=0.000000000000000E+00 beta (00000185)=0.129153914366739E+02 gamma(00000185)=0.129153914366739E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 185 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000185)=0.000000000000000E+00 beta (00000186)=0.133112578154517E+02 gamma(00000186)=0.133112578154517E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 186 z1= 1 0.207939791737792E-02 0.000000000000000E+00 z1= 2 0.233244231942920E-07 0.000000000000000E+00 z1= 3 0.108932738483475E-06 0.000000000000000E+00 alpha(00000186)=0.000000000000000E+00 beta (00000187)=0.127265506362402E+02 gamma(00000187)=0.127265506362402E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 187 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000187)=0.000000000000000E+00 beta (00000188)=0.134540116702343E+02 gamma(00000188)=0.134540116702343E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 188 z1= 1 -.185386723160327E-02 0.000000000000000E+00 z1= 2 -.199225619139896E-07 0.000000000000000E+00 z1= 3 -.109036463411319E-06 0.000000000000000E+00 alpha(00000188)=0.000000000000000E+00 beta (00000189)=0.129511692669245E+02 gamma(00000189)=0.129511692669245E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 189 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000189)=0.000000000000000E+00 beta (00000190)=0.137069666952595E+02 gamma(00000190)=0.137069666952595E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 190 z1= 1 0.163076986137258E-02 0.000000000000000E+00 z1= 2 0.160928020939526E-07 0.000000000000000E+00 z1= 3 0.108890994078884E-06 0.000000000000000E+00 alpha(00000190)=0.000000000000000E+00 beta (00000191)=0.128653305915014E+02 gamma(00000191)=0.128653305915014E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 191 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000191)=0.000000000000000E+00 beta (00000192)=0.134375825261866E+02 gamma(00000192)=0.134375825261866E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 192 z1= 1 -.143511058202770E-02 0.000000000000000E+00 z1= 2 -.133758056089506E-07 0.000000000000000E+00 z1= 3 -.106430666051800E-06 0.000000000000000E+00 alpha(00000192)=0.000000000000000E+00 beta (00000193)=0.127839848034801E+02 gamma(00000193)=0.127839848034801E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 193 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000193)=0.000000000000000E+00 beta (00000194)=0.131984572549995E+02 gamma(00000194)=0.131984572549995E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 194 z1= 1 0.131190567300017E-02 0.000000000000000E+00 z1= 2 0.139286605756184E-07 0.000000000000000E+00 z1= 3 0.104658300487267E-06 0.000000000000000E+00 alpha(00000194)=0.000000000000000E+00 beta (00000195)=0.126837492063895E+02 gamma(00000195)=0.126837492063895E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 195 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000195)=0.000000000000000E+00 beta (00000196)=0.133145754451245E+02 gamma(00000196)=0.133145754451245E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 196 z1= 1 -.121256070378766E-02 0.000000000000000E+00 z1= 2 -.106315335259358E-07 0.000000000000000E+00 z1= 3 -.100247947769469E-06 0.000000000000000E+00 alpha(00000196)=0.000000000000000E+00 beta (00000197)=0.126075489979748E+02 gamma(00000197)=0.126075489979748E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 197 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000197)=0.000000000000000E+00 beta (00000198)=0.136346679091700E+02 gamma(00000198)=0.136346679091700E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 198 z1= 1 0.114046825239087E-02 0.000000000000000E+00 z1= 2 0.574877083480210E-08 0.000000000000000E+00 z1= 3 0.942582185863407E-07 0.000000000000000E+00 alpha(00000198)=0.000000000000000E+00 beta (00000199)=0.126706455898361E+02 gamma(00000199)=0.126706455898361E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 199 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000199)=0.000000000000000E+00 beta (00000200)=0.134979840442127E+02 gamma(00000200)=0.134979840442127E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 200 z1= 1 -.113630784750268E-02 0.000000000000000E+00 z1= 2 -.223912535539904E-08 0.000000000000000E+00 z1= 3 -.912685786270268E-07 0.000000000000000E+00 alpha(00000200)=0.000000000000000E+00 beta (00000201)=0.126144785204870E+02 gamma(00000201)=0.126144785204870E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 201 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000201)=0.000000000000000E+00 beta (00000202)=0.133827090439611E+02 gamma(00000202)=0.133827090439611E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 202 z1= 1 0.113725403235079E-02 0.000000000000000E+00 z1= 2 0.646455859177643E-08 0.000000000000000E+00 z1= 3 0.905272417105847E-07 0.000000000000000E+00 alpha(00000202)=0.000000000000000E+00 beta (00000203)=0.127737664909217E+02 gamma(00000203)=0.127737664909217E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 203 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000203)=0.000000000000000E+00 beta (00000204)=0.135577204345506E+02 gamma(00000204)=0.135577204345506E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 204 z1= 1 -.111813649562787E-02 0.000000000000000E+00 z1= 2 -.165495525209294E-07 0.000000000000000E+00 z1= 3 -.874946694708187E-07 0.000000000000000E+00 alpha(00000204)=0.000000000000000E+00 beta (00000205)=0.128451022490485E+02 gamma(00000205)=0.128451022490485E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 205 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000205)=0.000000000000000E+00 beta (00000206)=0.134794017710417E+02 gamma(00000206)=0.134794017710417E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 206 z1= 1 0.117276639315365E-02 0.000000000000000E+00 z1= 2 0.265693574971054E-07 0.000000000000000E+00 z1= 3 0.852818415216210E-07 0.000000000000000E+00 alpha(00000206)=0.000000000000000E+00 beta (00000207)=0.127619770842102E+02 gamma(00000207)=0.127619770842102E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 207 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000207)=0.000000000000000E+00 beta (00000208)=0.133843617016336E+02 gamma(00000208)=0.133843617016336E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 208 z1= 1 -.124901224406371E-02 0.000000000000000E+00 z1= 2 -.305948840142664E-07 0.000000000000000E+00 z1= 3 -.848725109117406E-07 0.000000000000000E+00 alpha(00000208)=0.000000000000000E+00 beta (00000209)=0.126285792292844E+02 gamma(00000209)=0.126285792292844E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 209 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000209)=0.000000000000000E+00 beta (00000210)=0.135245907248173E+02 gamma(00000210)=0.135245907248173E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 210 z1= 1 0.133099582636831E-02 0.000000000000000E+00 z1= 2 0.256371532414770E-07 0.000000000000000E+00 z1= 3 0.843122867932075E-07 0.000000000000000E+00 alpha(00000210)=0.000000000000000E+00 beta (00000211)=0.126502755456593E+02 gamma(00000211)=0.126502755456593E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 211 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000211)=0.000000000000000E+00 beta (00000212)=0.135865808507868E+02 gamma(00000212)=0.135865808507868E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 212 z1= 1 -.133865548382505E-02 0.000000000000000E+00 z1= 2 -.205966157375975E-07 0.000000000000000E+00 z1= 3 -.873877587451036E-07 0.000000000000000E+00 alpha(00000212)=0.000000000000000E+00 beta (00000213)=0.126861053938343E+02 gamma(00000213)=0.126861053938343E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 213 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000213)=0.000000000000000E+00 beta (00000214)=0.134728746983157E+02 gamma(00000214)=0.134728746983157E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 214 z1= 1 0.123945687335569E-02 0.000000000000000E+00 z1= 2 0.166135795138384E-07 0.000000000000000E+00 z1= 3 0.927091144721504E-07 0.000000000000000E+00 alpha(00000214)=0.000000000000000E+00 beta (00000215)=0.125569298571154E+02 gamma(00000215)=0.125569298571154E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 215 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000215)=0.000000000000000E+00 beta (00000216)=0.132491070238090E+02 gamma(00000216)=0.132491070238090E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 216 z1= 1 -.111656318504560E-02 0.000000000000000E+00 z1= 2 -.148995788502165E-07 0.000000000000000E+00 z1= 3 -.971834263224260E-07 0.000000000000000E+00 alpha(00000216)=0.000000000000000E+00 beta (00000217)=0.124622993730917E+02 gamma(00000217)=0.124622993730917E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 217 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000217)=0.000000000000000E+00 beta (00000218)=0.136511866083870E+02 gamma(00000218)=0.136511866083870E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 218 z1= 1 0.924455580437357E-03 0.000000000000000E+00 z1= 2 0.136726765308931E-07 0.000000000000000E+00 z1= 3 0.981152112673094E-07 0.000000000000000E+00 alpha(00000218)=0.000000000000000E+00 beta (00000219)=0.127279557348590E+02 gamma(00000219)=0.127279557348590E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 219 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000219)=0.000000000000000E+00 beta (00000220)=0.134284313839443E+02 gamma(00000220)=0.134284313839443E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 220 z1= 1 -.774281281841030E-03 0.000000000000000E+00 z1= 2 -.124179367292504E-07 0.000000000000000E+00 z1= 3 -.983345285195483E-07 0.000000000000000E+00 alpha(00000220)=0.000000000000000E+00 beta (00000221)=0.127708029379893E+02 gamma(00000221)=0.127708029379893E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 221 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000221)=0.000000000000000E+00 beta (00000222)=0.132931665896048E+02 gamma(00000222)=0.132931665896048E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 222 z1= 1 0.618116144990393E-03 0.000000000000000E+00 z1= 2 0.161778577895122E-07 0.000000000000000E+00 z1= 3 0.999116180592390E-07 0.000000000000000E+00 alpha(00000222)=0.000000000000000E+00 beta (00000223)=0.128285615034577E+02 gamma(00000223)=0.128285615034577E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 223 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000223)=0.000000000000000E+00 beta (00000224)=0.132059500563567E+02 gamma(00000224)=0.132059500563567E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 224 z1= 1 -.427794310437200E-03 0.000000000000000E+00 z1= 2 -.211902544643150E-07 0.000000000000000E+00 z1= 3 -.102738715912232E-06 0.000000000000000E+00 alpha(00000224)=0.000000000000000E+00 beta (00000225)=0.129768286196257E+02 gamma(00000225)=0.129768286196257E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 225 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000225)=0.000000000000000E+00 beta (00000226)=0.133547434768259E+02 gamma(00000226)=0.133547434768259E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 226 z1= 1 0.233656732420910E-03 0.000000000000000E+00 z1= 2 0.224989176213219E-07 0.000000000000000E+00 z1= 3 0.105054218553719E-06 0.000000000000000E+00 alpha(00000226)=0.000000000000000E+00 beta (00000227)=0.128221370313782E+02 gamma(00000227)=0.128221370313782E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 227 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000227)=0.000000000000000E+00 beta (00000228)=0.135114456239111E+02 gamma(00000228)=0.135114456239111E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 228 z1= 1 -.742532585807773E-04 0.000000000000000E+00 z1= 2 -.225517795861274E-07 0.000000000000000E+00 z1= 3 -.106805851868866E-06 0.000000000000000E+00 alpha(00000228)=0.000000000000000E+00 beta (00000229)=0.127023354721999E+02 gamma(00000229)=0.127023354721999E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 229 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000229)=0.000000000000000E+00 beta (00000230)=0.134493711380061E+02 gamma(00000230)=0.134493711380061E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 230 z1= 1 -.479590047025085E-04 0.000000000000000E+00 z1= 2 0.176864559057327E-07 0.000000000000000E+00 z1= 3 0.105514590310291E-06 0.000000000000000E+00 alpha(00000230)=0.000000000000000E+00 beta (00000231)=0.129121573034282E+02 gamma(00000231)=0.129121573034282E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 231 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000231)=0.000000000000000E+00 beta (00000232)=0.137270840910203E+02 gamma(00000232)=0.137270840910203E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 232 z1= 1 0.115645708386509E-03 0.000000000000000E+00 z1= 2 -.156767722830908E-07 0.000000000000000E+00 z1= 3 -.104091090756273E-06 0.000000000000000E+00 alpha(00000232)=0.000000000000000E+00 beta (00000233)=0.127783709774266E+02 gamma(00000233)=0.127783709774266E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 233 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000233)=0.000000000000000E+00 beta (00000234)=0.133505833546879E+02 gamma(00000234)=0.133505833546879E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 234 z1= 1 -.182071244332290E-03 0.000000000000000E+00 z1= 2 0.108110230906400E-07 0.000000000000000E+00 z1= 3 0.109363312453061E-06 0.000000000000000E+00 alpha(00000234)=0.000000000000000E+00 beta (00000235)=0.125912995049460E+02 gamma(00000235)=0.125912995049460E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 235 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000235)=0.000000000000000E+00 beta (00000236)=0.133931010316806E+02 gamma(00000236)=0.133931010316806E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 236 z1= 1 0.215509254188460E-03 0.000000000000000E+00 z1= 2 -.766878136687632E-08 0.000000000000000E+00 z1= 3 -.114195599372371E-06 0.000000000000000E+00 alpha(00000236)=0.000000000000000E+00 beta (00000237)=0.128916028327734E+02 gamma(00000237)=0.128916028327734E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 237 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000237)=0.000000000000000E+00 beta (00000238)=0.135199842445094E+02 gamma(00000238)=0.135199842445094E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 238 z1= 1 -.249003966516678E-03 0.000000000000000E+00 z1= 2 -.228907503282277E-08 0.000000000000000E+00 z1= 3 0.120243915655298E-06 0.000000000000000E+00 alpha(00000238)=0.000000000000000E+00 beta (00000239)=0.127638002061042E+02 gamma(00000239)=0.127638002061042E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 239 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000239)=0.000000000000000E+00 beta (00000240)=0.133599249731501E+02 gamma(00000240)=0.133599249731501E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 240 z1= 1 0.256594758382675E-03 0.000000000000000E+00 z1= 2 0.874674408552975E-08 0.000000000000000E+00 z1= 3 -.123566478470725E-06 0.000000000000000E+00 alpha(00000240)=0.000000000000000E+00 beta (00000241)=0.127491482663613E+02 gamma(00000241)=0.127491482663613E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 241 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000241)=0.000000000000000E+00 beta (00000242)=0.134030851350293E+02 gamma(00000242)=0.134030851350293E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 242 z1= 1 -.218610772041756E-03 0.000000000000000E+00 z1= 2 -.759293130084791E-08 0.000000000000000E+00 z1= 3 0.120574727652722E-06 0.000000000000000E+00 alpha(00000242)=0.000000000000000E+00 beta (00000243)=0.128891581252811E+02 gamma(00000243)=0.128891581252811E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 243 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000243)=0.000000000000000E+00 beta (00000244)=0.135143970912189E+02 gamma(00000244)=0.135143970912189E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 244 z1= 1 0.177566814942388E-03 0.000000000000000E+00 z1= 2 0.455023162074589E-08 0.000000000000000E+00 z1= 3 -.118713744721056E-06 0.000000000000000E+00 alpha(00000244)=0.000000000000000E+00 beta (00000245)=0.125468367620293E+02 gamma(00000245)=0.125468367620293E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 245 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000245)=0.000000000000000E+00 beta (00000246)=0.130512646017233E+02 gamma(00000246)=0.130512646017233E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 246 z1= 1 -.695051608718537E-04 0.000000000000000E+00 z1= 2 0.395521702065485E-08 0.000000000000000E+00 z1= 3 0.121605217102950E-06 0.000000000000000E+00 alpha(00000246)=0.000000000000000E+00 beta (00000247)=0.125670620338258E+02 gamma(00000247)=0.125670620338258E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 247 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000247)=0.000000000000000E+00 beta (00000248)=0.133323980726147E+02 gamma(00000248)=0.133323980726147E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 248 z1= 1 -.259199231997520E-04 0.000000000000000E+00 z1= 2 -.107372754637111E-07 0.000000000000000E+00 z1= 3 -.125233930155753E-06 0.000000000000000E+00 alpha(00000248)=0.000000000000000E+00 beta (00000249)=0.127879965741994E+02 gamma(00000249)=0.127879965741994E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 249 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000249)=0.000000000000000E+00 beta (00000250)=0.134569251970934E+02 gamma(00000250)=0.134569251970934E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 250 z1= 1 0.128059915594002E-03 0.000000000000000E+00 z1= 2 0.153581395686934E-07 0.000000000000000E+00 z1= 3 0.132022042344856E-06 0.000000000000000E+00 alpha(00000250)=0.000000000000000E+00 beta (00000251)=0.125505299889334E+02 gamma(00000251)=0.125505299889334E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 251 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000251)=0.000000000000000E+00 beta (00000252)=0.132839967869087E+02 gamma(00000252)=0.132839967869087E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 252 z1= 1 -.178474694069186E-03 0.000000000000000E+00 z1= 2 -.137036489751205E-07 0.000000000000000E+00 z1= 3 -.143055666985102E-06 0.000000000000000E+00 alpha(00000252)=0.000000000000000E+00 beta (00000253)=0.129335049179351E+02 gamma(00000253)=0.129335049179351E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 253 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000253)=0.000000000000000E+00 beta (00000254)=0.135153286070108E+02 gamma(00000254)=0.135153286070108E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 254 z1= 1 0.150115990710538E-03 0.000000000000000E+00 z1= 2 0.129542551746339E-07 0.000000000000000E+00 z1= 3 0.150467407713422E-06 0.000000000000000E+00 alpha(00000254)=0.000000000000000E+00 beta (00000255)=0.128017616037854E+02 gamma(00000255)=0.128017616037854E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 255 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000255)=0.000000000000000E+00 beta (00000256)=0.136717468163441E+02 gamma(00000256)=0.136717468163441E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 256 z1= 1 -.136180064748317E-03 0.000000000000000E+00 z1= 2 -.155326315464180E-07 0.000000000000000E+00 z1= 3 -.151923571217760E-06 0.000000000000000E+00 alpha(00000256)=0.000000000000000E+00 beta (00000257)=0.128304023410005E+02 gamma(00000257)=0.128304023410005E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 257 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000257)=0.000000000000000E+00 beta (00000258)=0.134220701124928E+02 gamma(00000258)=0.134220701124928E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 258 z1= 1 0.137410615793950E-03 0.000000000000000E+00 z1= 2 0.199676420814532E-07 0.000000000000000E+00 z1= 3 0.150626729947972E-06 0.000000000000000E+00 alpha(00000258)=0.000000000000000E+00 beta (00000259)=0.130323956497234E+02 gamma(00000259)=0.130323956497234E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 259 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000259)=0.000000000000000E+00 beta (00000260)=0.135344438016698E+02 gamma(00000260)=0.135344438016698E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 260 z1= 1 -.919445274131182E-04 0.000000000000000E+00 z1= 2 -.169494144474855E-07 0.000000000000000E+00 z1= 3 -.147311300800822E-06 0.000000000000000E+00 alpha(00000260)=0.000000000000000E+00 beta (00000261)=0.127717838007241E+02 gamma(00000261)=0.127717838007241E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 261 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000261)=0.000000000000000E+00 beta (00000262)=0.133224139219482E+02 gamma(00000262)=0.133224139219482E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 262 z1= 1 0.470298519717636E-04 0.000000000000000E+00 z1= 2 0.876896539495770E-08 0.000000000000000E+00 z1= 3 0.145628455211814E-06 0.000000000000000E+00 alpha(00000262)=0.000000000000000E+00 beta (00000263)=0.126369575646810E+02 gamma(00000263)=0.126369575646810E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 263 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000263)=0.000000000000000E+00 beta (00000264)=0.132589101154249E+02 gamma(00000264)=0.132589101154249E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 264 z1= 1 -.374559552561611E-05 0.000000000000000E+00 z1= 2 0.203971343721437E-08 0.000000000000000E+00 z1= 3 -.149924160639144E-06 0.000000000000000E+00 alpha(00000264)=0.000000000000000E+00 beta (00000265)=0.127325992255919E+02 gamma(00000265)=0.127325992255919E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 265 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000265)=0.000000000000000E+00 beta (00000266)=0.134482051800077E+02 gamma(00000266)=0.134482051800077E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 266 z1= 1 0.576796262454719E-05 0.000000000000000E+00 z1= 2 -.328142884913063E-08 0.000000000000000E+00 z1= 3 0.154690998925978E-06 0.000000000000000E+00 alpha(00000266)=0.000000000000000E+00 beta (00000267)=0.127991463567134E+02 gamma(00000267)=0.127991463567134E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 267 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000267)=0.000000000000000E+00 beta (00000268)=0.133513104290905E+02 gamma(00000268)=0.133513104290905E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 268 z1= 1 -.561201572372091E-04 0.000000000000000E+00 z1= 2 -.156462359734988E-08 0.000000000000000E+00 z1= 3 -.159294394055476E-06 0.000000000000000E+00 alpha(00000268)=0.000000000000000E+00 beta (00000269)=0.126158983901676E+02 gamma(00000269)=0.126158983901676E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 269 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000269)=0.000000000000000E+00 beta (00000270)=0.135205362748245E+02 gamma(00000270)=0.135205362748245E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 270 z1= 1 0.126580967699363E-03 0.000000000000000E+00 z1= 2 0.114221756948585E-07 0.000000000000000E+00 z1= 3 0.164742413363893E-06 0.000000000000000E+00 alpha(00000270)=0.000000000000000E+00 beta (00000271)=0.130326467374182E+02 gamma(00000271)=0.130326467374182E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 271 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000271)=0.000000000000000E+00 beta (00000272)=0.132961234010765E+02 gamma(00000272)=0.132961234010765E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 272 z1= 1 -.191091130299099E-03 0.000000000000000E+00 z1= 2 -.190901487499839E-07 0.000000000000000E+00 z1= 3 -.185457732597443E-06 0.000000000000000E+00 alpha(00000272)=0.000000000000000E+00 beta (00000273)=0.127265903760148E+02 gamma(00000273)=0.127265903760148E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 273 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000273)=0.000000000000000E+00 beta (00000274)=0.134988999510834E+02 gamma(00000274)=0.134988999510834E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 274 z1= 1 0.169627188330681E-03 0.000000000000000E+00 z1= 2 0.236128857916337E-07 0.000000000000000E+00 z1= 3 0.192411938992182E-06 0.000000000000000E+00 alpha(00000274)=0.000000000000000E+00 beta (00000275)=0.128619365201656E+02 gamma(00000275)=0.128619365201656E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 275 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000275)=0.000000000000000E+00 beta (00000276)=0.137442800886495E+02 gamma(00000276)=0.137442800886495E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 276 z1= 1 -.142010029683989E-03 0.000000000000000E+00 z1= 2 -.245351297837454E-07 0.000000000000000E+00 z1= 3 -.193483277403613E-06 0.000000000000000E+00 alpha(00000276)=0.000000000000000E+00 beta (00000277)=0.127469271396003E+02 gamma(00000277)=0.127469271396003E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 277 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000277)=0.000000000000000E+00 beta (00000278)=0.131865643578341E+02 gamma(00000278)=0.131865643578341E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 278 z1= 1 0.108780568736252E-03 0.000000000000000E+00 z1= 2 0.214003927859890E-07 0.000000000000000E+00 z1= 3 0.200286633973316E-06 0.000000000000000E+00 alpha(00000278)=0.000000000000000E+00 beta (00000279)=0.125348595354360E+02 gamma(00000279)=0.125348595354360E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 279 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000279)=0.000000000000000E+00 beta (00000280)=0.133611705101487E+02 gamma(00000280)=0.133611705101487E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 280 z1= 1 -.751969632195437E-04 0.000000000000000E+00 z1= 2 -.140310900910087E-07 0.000000000000000E+00 z1= 3 -.196054412754111E-06 0.000000000000000E+00 alpha(00000280)=0.000000000000000E+00 beta (00000281)=0.128735884693595E+02 gamma(00000281)=0.128735884693595E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 281 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000281)=0.000000000000000E+00 beta (00000282)=0.132965515798225E+02 gamma(00000282)=0.132965515798225E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 282 z1= 1 0.268202204131446E-04 0.000000000000000E+00 z1= 2 0.897413352570625E-08 0.000000000000000E+00 z1= 3 0.195188870084591E-06 0.000000000000000E+00 alpha(00000282)=0.000000000000000E+00 beta (00000283)=0.125943182074327E+02 gamma(00000283)=0.125943182074327E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 283 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000283)=0.000000000000000E+00 beta (00000284)=0.132145348474454E+02 gamma(00000284)=0.132145348474454E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 284 z1= 1 0.591696284768326E-04 0.000000000000000E+00 z1= 2 -.711480848888946E-08 0.000000000000000E+00 z1= 3 -.187633788177854E-06 0.000000000000000E+00 alpha(00000284)=0.000000000000000E+00 beta (00000285)=0.126626665169496E+02 gamma(00000285)=0.126626665169496E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 285 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000285)=0.000000000000000E+00 beta (00000286)=0.134123818545094E+02 gamma(00000286)=0.134123818545094E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 286 z1= 1 -.191801465650984E-03 0.000000000000000E+00 z1= 2 0.712459513087238E-08 0.000000000000000E+00 z1= 3 0.184268009193204E-06 0.000000000000000E+00 alpha(00000286)=0.000000000000000E+00 beta (00000287)=0.126243415637657E+02 gamma(00000287)=0.126243415637657E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 287 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000287)=0.000000000000000E+00 beta (00000288)=0.130877011364979E+02 gamma(00000288)=0.130877011364979E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 288 z1= 1 0.350550457472849E-03 0.000000000000000E+00 z1= 2 -.608761951568712E-08 0.000000000000000E+00 z1= 3 -.190591423494390E-06 0.000000000000000E+00 alpha(00000288)=0.000000000000000E+00 beta (00000289)=0.127644144082198E+02 gamma(00000289)=0.127644144082198E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 289 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000289)=0.000000000000000E+00 beta (00000290)=0.134269533903187E+02 gamma(00000290)=0.134269533903187E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 290 z1= 1 -.501944967691783E-03 0.000000000000000E+00 z1= 2 0.344276616937034E-08 0.000000000000000E+00 z1= 3 0.197061017347816E-06 0.000000000000000E+00 alpha(00000290)=0.000000000000000E+00 beta (00000291)=0.127608142942973E+02 gamma(00000291)=0.127608142942973E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 291 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000291)=0.000000000000000E+00 beta (00000292)=0.131981560343178E+02 gamma(00000292)=0.131981560343178E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 292 z1= 1 0.625920024731239E-03 0.000000000000000E+00 z1= 2 -.279954840039232E-08 0.000000000000000E+00 z1= 3 -.204755787311492E-06 0.000000000000000E+00 alpha(00000292)=0.000000000000000E+00 beta (00000293)=0.126409931949805E+02 gamma(00000293)=0.126409931949805E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 293 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000293)=0.000000000000000E+00 beta (00000294)=0.135270549807920E+02 gamma(00000294)=0.135270549807920E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 294 z1= 1 -.726201004543468E-03 0.000000000000000E+00 z1= 2 0.904924736273155E-09 0.000000000000000E+00 z1= 3 0.201333797093990E-06 0.000000000000000E+00 alpha(00000294)=0.000000000000000E+00 beta (00000295)=0.129785201583456E+02 gamma(00000295)=0.129785201583456E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 295 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000295)=0.000000000000000E+00 beta (00000296)=0.135626793387397E+02 gamma(00000296)=0.135626793387397E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 296 z1= 1 0.768646706968257E-03 0.000000000000000E+00 z1= 2 -.304365980856314E-08 0.000000000000000E+00 z1= 3 -.196867345254100E-06 0.000000000000000E+00 alpha(00000296)=0.000000000000000E+00 beta (00000297)=0.127909952630763E+02 gamma(00000297)=0.127909952630763E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 297 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000297)=0.000000000000000E+00 beta (00000298)=0.133438351757334E+02 gamma(00000298)=0.133438351757334E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 298 z1= 1 -.707217746303754E-03 0.000000000000000E+00 z1= 2 0.455182497726900E-08 0.000000000000000E+00 z1= 3 0.192846703742533E-06 0.000000000000000E+00 alpha(00000298)=0.000000000000000E+00 beta (00000299)=0.130103409693399E+02 gamma(00000299)=0.130103409693399E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 299 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000299)=0.000000000000000E+00 beta (00000300)=0.136894544612538E+02 gamma(00000300)=0.136894544612538E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 300 z1= 1 0.684043506959373E-03 0.000000000000000E+00 z1= 2 -.756845136042072E-08 0.000000000000000E+00 z1= 3 -.186325768384085E-06 0.000000000000000E+00 alpha(00000300)=0.000000000000000E+00 beta (00000301)=0.127328195612318E+02 gamma(00000301)=0.127328195612318E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 301 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000301)=0.000000000000000E+00 beta (00000302)=0.132016655469620E+02 gamma(00000302)=0.132016655469620E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 302 z1= 1 -.646439193606308E-03 0.000000000000000E+00 z1= 2 0.674226915053575E-08 0.000000000000000E+00 z1= 3 0.193064807468124E-06 0.000000000000000E+00 alpha(00000302)=0.000000000000000E+00 beta (00000303)=0.127866560095119E+02 gamma(00000303)=0.127866560095119E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 303 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000303)=0.000000000000000E+00 beta (00000304)=0.135650730485512E+02 gamma(00000304)=0.135650730485512E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 304 z1= 1 0.550090219878729E-03 0.000000000000000E+00 z1= 2 -.794289424033492E-08 0.000000000000000E+00 z1= 3 -.200401094503481E-06 0.000000000000000E+00 alpha(00000304)=0.000000000000000E+00 beta (00000305)=0.128308365694812E+02 gamma(00000305)=0.128308365694812E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 305 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000305)=0.000000000000000E+00 beta (00000306)=0.134497841178766E+02 gamma(00000306)=0.134497841178766E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 306 z1= 1 -.425158038628542E-03 0.000000000000000E+00 z1= 2 0.569501527533656E-09 0.000000000000000E+00 z1= 3 0.210857773972131E-06 0.000000000000000E+00 alpha(00000306)=0.000000000000000E+00 beta (00000307)=0.127985148881293E+02 gamma(00000307)=0.127985148881293E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 307 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000307)=0.000000000000000E+00 beta (00000308)=0.135697988695593E+02 gamma(00000308)=0.135697988695593E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 308 z1= 1 0.238229622289175E-03 0.000000000000000E+00 z1= 2 0.632321356906773E-08 0.000000000000000E+00 z1= 3 -.210707875256079E-06 0.000000000000000E+00 alpha(00000308)=0.000000000000000E+00 beta (00000309)=0.127887287745089E+02 gamma(00000309)=0.127887287745089E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 309 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000309)=0.000000000000000E+00 beta (00000310)=0.133080250770123E+02 gamma(00000310)=0.133080250770123E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 310 z1= 1 -.690347592661508E-04 0.000000000000000E+00 z1= 2 -.108201030461774E-07 0.000000000000000E+00 z1= 3 0.212911528125093E-06 0.000000000000000E+00 alpha(00000310)=0.000000000000000E+00 beta (00000311)=0.127284891063720E+02 gamma(00000311)=0.127284891063720E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 311 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000311)=0.000000000000000E+00 beta (00000312)=0.134432025346299E+02 gamma(00000312)=0.134432025346299E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 312 z1= 1 -.754012815345623E-04 0.000000000000000E+00 z1= 2 0.113483736802287E-07 0.000000000000000E+00 z1= 3 -.211501503723493E-06 0.000000000000000E+00 alpha(00000312)=0.000000000000000E+00 beta (00000313)=0.128577025935403E+02 gamma(00000313)=0.128577025935403E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 313 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000313)=0.000000000000000E+00 beta (00000314)=0.132270540865441E+02 gamma(00000314)=0.132270540865441E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 314 z1= 1 0.260480423778858E-03 0.000000000000000E+00 z1= 2 -.385614933560985E-08 0.000000000000000E+00 z1= 3 0.219052140331636E-06 0.000000000000000E+00 alpha(00000314)=0.000000000000000E+00 beta (00000315)=0.124468859918063E+02 gamma(00000315)=0.124468859918063E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 315 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000315)=0.000000000000000E+00 beta (00000316)=0.134574571605253E+02 gamma(00000316)=0.134574571605253E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 316 z1= 1 -.405193117104193E-03 0.000000000000000E+00 z1= 2 -.591040468281810E-08 0.000000000000000E+00 z1= 3 -.220102571945506E-06 0.000000000000000E+00 alpha(00000316)=0.000000000000000E+00 beta (00000317)=0.125628261760240E+02 gamma(00000317)=0.125628261760240E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 317 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000317)=0.000000000000000E+00 beta (00000318)=0.134454788502416E+02 gamma(00000318)=0.134454788502416E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 318 z1= 1 0.508402142490534E-03 0.000000000000000E+00 z1= 2 0.154502051335006E-07 0.000000000000000E+00 z1= 3 0.227776342717105E-06 0.000000000000000E+00 alpha(00000318)=0.000000000000000E+00 beta (00000319)=0.125694664450283E+02 gamma(00000319)=0.125694664450283E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 319 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000319)=0.000000000000000E+00 beta (00000320)=0.132681022789757E+02 gamma(00000320)=0.132681022789757E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 320 z1= 1 -.614341014316207E-03 0.000000000000000E+00 z1= 2 -.179512356962737E-07 0.000000000000000E+00 z1= 3 -.237428488482697E-06 0.000000000000000E+00 alpha(00000320)=0.000000000000000E+00 beta (00000321)=0.128765188766459E+02 gamma(00000321)=0.128765188766459E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 321 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000321)=0.000000000000000E+00 beta (00000322)=0.135399507032668E+02 gamma(00000322)=0.135399507032668E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 322 z1= 1 0.611758813211269E-03 0.000000000000000E+00 z1= 2 0.205805058333883E-07 0.000000000000000E+00 z1= 3 0.242712496217098E-06 0.000000000000000E+00 alpha(00000322)=0.000000000000000E+00 beta (00000323)=0.127481120669937E+02 gamma(00000323)=0.127481120669937E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 323 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000323)=0.000000000000000E+00 beta (00000324)=0.132689451816167E+02 gamma(00000324)=0.132689451816167E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 324 z1= 1 -.593168682398789E-03 0.000000000000000E+00 z1= 2 -.174833337401609E-07 0.000000000000000E+00 z1= 3 -.252876005904599E-06 0.000000000000000E+00 alpha(00000324)=0.000000000000000E+00 beta (00000325)=0.127936777327832E+02 gamma(00000325)=0.127936777327832E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 325 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000325)=0.000000000000000E+00 beta (00000326)=0.137030981721921E+02 gamma(00000326)=0.137030981721921E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 326 z1= 1 0.514694233265293E-03 0.000000000000000E+00 z1= 2 0.193795105132670E-07 0.000000000000000E+00 z1= 3 0.253705705933766E-06 0.000000000000000E+00 alpha(00000326)=0.000000000000000E+00 beta (00000327)=0.126567250472013E+02 gamma(00000327)=0.126567250472013E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 327 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000327)=0.000000000000000E+00 beta (00000328)=0.132711549882042E+02 gamma(00000328)=0.132711549882042E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 328 z1= 1 -.371424856066639E-03 0.000000000000000E+00 z1= 2 -.205773886508779E-07 0.000000000000000E+00 z1= 3 -.265805774383792E-06 0.000000000000000E+00 alpha(00000328)=0.000000000000000E+00 beta (00000329)=0.128091301638480E+02 gamma(00000329)=0.128091301638480E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 329 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000329)=0.000000000000000E+00 beta (00000330)=0.136226098531016E+02 gamma(00000330)=0.136226098531016E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 330 z1= 1 0.203149829527911E-03 0.000000000000000E+00 z1= 2 0.295799284046917E-07 0.000000000000000E+00 z1= 3 0.273535491571511E-06 0.000000000000000E+00 alpha(00000330)=0.000000000000000E+00 beta (00000331)=0.126673945023668E+02 gamma(00000331)=0.126673945023668E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 331 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000331)=0.000000000000000E+00 beta (00000332)=0.133665358639019E+02 gamma(00000332)=0.133665358639019E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 332 z1= 1 0.641288173316296E-05 0.000000000000000E+00 z1= 2 -.324812809682738E-07 0.000000000000000E+00 z1= 3 -.289790562626319E-06 0.000000000000000E+00 alpha(00000332)=0.000000000000000E+00 beta (00000333)=0.128362321029798E+02 gamma(00000333)=0.128362321029798E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 333 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000333)=0.000000000000000E+00 beta (00000334)=0.134614552353563E+02 gamma(00000334)=0.134614552353563E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 334 z1= 1 -.150863377620337E-03 0.000000000000000E+00 z1= 2 0.376770072283133E-07 0.000000000000000E+00 z1= 3 0.305029884207445E-06 0.000000000000000E+00 alpha(00000334)=0.000000000000000E+00 beta (00000335)=0.124684176891291E+02 gamma(00000335)=0.124684176891291E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 335 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000335)=0.000000000000000E+00 beta (00000336)=0.130933459011621E+02 gamma(00000336)=0.130933459011621E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 336 z1= 1 0.269460724300116E-03 0.000000000000000E+00 z1= 2 -.373095916416429E-07 0.000000000000000E+00 z1= 3 -.316983815500408E-06 0.000000000000000E+00 alpha(00000336)=0.000000000000000E+00 beta (00000337)=0.129072714531106E+02 gamma(00000337)=0.129072714531106E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 337 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000337)=0.000000000000000E+00 beta (00000338)=0.135020008641032E+02 gamma(00000338)=0.135020008641032E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 338 z1= 1 -.431475102899173E-03 0.000000000000000E+00 z1= 2 0.375879178205873E-07 0.000000000000000E+00 z1= 3 0.324906942943928E-06 0.000000000000000E+00 alpha(00000338)=0.000000000000000E+00 beta (00000339)=0.126384319307957E+02 gamma(00000339)=0.126384319307957E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 339 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000339)=0.000000000000000E+00 beta (00000340)=0.132426377687523E+02 gamma(00000340)=0.132426377687523E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 340 z1= 1 0.596967828934074E-03 0.000000000000000E+00 z1= 2 -.317503121788701E-07 0.000000000000000E+00 z1= 3 -.332397156112925E-06 0.000000000000000E+00 alpha(00000340)=0.000000000000000E+00 beta (00000341)=0.126701057973019E+02 gamma(00000341)=0.126701057973019E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 341 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000341)=0.000000000000000E+00 beta (00000342)=0.136755697683106E+02 gamma(00000342)=0.136755697683106E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 342 z1= 1 -.713361913985406E-03 0.000000000000000E+00 z1= 2 0.336731555001775E-07 0.000000000000000E+00 z1= 3 0.328216714779058E-06 0.000000000000000E+00 alpha(00000342)=0.000000000000000E+00 beta (00000343)=0.127946152137579E+02 gamma(00000343)=0.127946152137579E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 343 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000343)=0.000000000000000E+00 beta (00000344)=0.135430060492712E+02 gamma(00000344)=0.135430060492712E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 344 z1= 1 0.859062656299784E-03 0.000000000000000E+00 z1= 2 -.373913174582952E-07 0.000000000000000E+00 z1= 3 -.331795063119732E-06 0.000000000000000E+00 alpha(00000344)=0.000000000000000E+00 beta (00000345)=0.129528402420676E+02 gamma(00000345)=0.129528402420676E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 345 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000345)=0.000000000000000E+00 beta (00000346)=0.134557756194667E+02 gamma(00000346)=0.134557756194667E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 346 z1= 1 -.104619448033402E-02 0.000000000000000E+00 z1= 2 0.401408766100529E-07 0.000000000000000E+00 z1= 3 0.341618349243176E-06 0.000000000000000E+00 alpha(00000346)=0.000000000000000E+00 beta (00000347)=0.125651993966796E+02 gamma(00000347)=0.125651993966796E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 347 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000347)=0.000000000000000E+00 beta (00000348)=0.134781650133292E+02 gamma(00000348)=0.134781650133292E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 348 z1= 1 0.117046711961940E-02 0.000000000000000E+00 z1= 2 -.328090946132096E-07 0.000000000000000E+00 z1= 3 -.345343851022644E-06 0.000000000000000E+00 alpha(00000348)=0.000000000000000E+00 beta (00000349)=0.129740086307102E+02 gamma(00000349)=0.129740086307102E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 349 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000349)=0.000000000000000E+00 beta (00000350)=0.134304556076026E+02 gamma(00000350)=0.134304556076026E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 350 z1= 1 -.135438265017344E-02 0.000000000000000E+00 z1= 2 0.354430275734032E-07 0.000000000000000E+00 z1= 3 0.353939621591500E-06 0.000000000000000E+00 alpha(00000350)=0.000000000000000E+00 beta (00000351)=0.125507893738060E+02 gamma(00000351)=0.125507893738060E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 351 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000351)=0.000000000000000E+00 beta (00000352)=0.134336935243286E+02 gamma(00000352)=0.134336935243286E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 352 z1= 1 0.143635044775605E-02 0.000000000000000E+00 z1= 2 -.307329387917287E-07 0.000000000000000E+00 z1= 3 -.354539743211649E-06 0.000000000000000E+00 alpha(00000352)=0.000000000000000E+00 beta (00000353)=0.129530404457713E+02 gamma(00000353)=0.129530404457713E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 353 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000353)=0.000000000000000E+00 beta (00000354)=0.132884544807235E+02 gamma(00000354)=0.132884544807235E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 354 z1= 1 -.157629170772134E-02 0.000000000000000E+00 z1= 2 0.288981323840094E-07 0.000000000000000E+00 z1= 3 0.362699428644187E-06 0.000000000000000E+00 alpha(00000354)=0.000000000000000E+00 beta (00000355)=0.124741654218916E+02 gamma(00000355)=0.124741654218916E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 355 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000355)=0.000000000000000E+00 beta (00000356)=0.136132722269076E+02 gamma(00000356)=0.136132722269076E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 356 z1= 1 0.166844128714281E-02 0.000000000000000E+00 z1= 2 -.255157450855959E-07 0.000000000000000E+00 z1= 3 -.351651896434617E-06 0.000000000000000E+00 alpha(00000356)=0.000000000000000E+00 beta (00000357)=0.128737369424429E+02 gamma(00000357)=0.128737369424429E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 357 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000357)=0.000000000000000E+00 beta (00000358)=0.136862077580065E+02 gamma(00000358)=0.136862077580065E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 358 z1= 1 -.178748579021513E-02 0.000000000000000E+00 z1= 2 0.209279044090065E-07 0.000000000000000E+00 z1= 3 0.352742239086937E-06 0.000000000000000E+00 alpha(00000358)=0.000000000000000E+00 beta (00000359)=0.126589862967578E+02 gamma(00000359)=0.126589862967578E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 359 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000359)=0.000000000000000E+00 beta (00000360)=0.138519000063650E+02 gamma(00000360)=0.138519000063650E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 360 z1= 1 0.183616495710468E-02 0.000000000000000E+00 z1= 2 -.167005002834654E-07 0.000000000000000E+00 z1= 3 -.349083161862453E-06 0.000000000000000E+00 alpha(00000360)=0.000000000000000E+00 beta (00000361)=0.124137605249768E+02 gamma(00000361)=0.124137605249768E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 361 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000361)=0.000000000000000E+00 beta (00000362)=0.134319953601465E+02 gamma(00000362)=0.134319953601465E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 362 z1= 1 -.191602155897039E-02 0.000000000000000E+00 z1= 2 0.171031275708784E-07 0.000000000000000E+00 z1= 3 0.348510575185271E-06 0.000000000000000E+00 alpha(00000362)=0.000000000000000E+00 beta (00000363)=0.128802108234803E+02 gamma(00000363)=0.128802108234803E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 363 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000363)=0.000000000000000E+00 beta (00000364)=0.135105204287260E+02 gamma(00000364)=0.135105204287260E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 364 z1= 1 0.201944015755747E-02 0.000000000000000E+00 z1= 2 -.251725027163897E-07 0.000000000000000E+00 z1= 3 -.362083311588715E-06 0.000000000000000E+00 alpha(00000364)=0.000000000000000E+00 beta (00000365)=0.123005743236478E+02 gamma(00000365)=0.123005743236478E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 365 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000365)=0.000000000000000E+00 beta (00000366)=0.129057210559566E+02 gamma(00000366)=0.129057210559566E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 366 z1= 1 -.211648623256485E-02 0.000000000000000E+00 z1= 2 0.299197041538947E-07 0.000000000000000E+00 z1= 3 0.376628409059270E-06 0.000000000000000E+00 alpha(00000366)=0.000000000000000E+00 beta (00000367)=0.127030944977500E+02 gamma(00000367)=0.127030944977500E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 367 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000367)=0.000000000000000E+00 beta (00000368)=0.134769695026878E+02 gamma(00000368)=0.134769695026878E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 368 z1= 1 0.214970404057204E-02 0.000000000000000E+00 z1= 2 -.311594008151929E-07 0.000000000000000E+00 z1= 3 -.383164740272218E-06 0.000000000000000E+00 alpha(00000368)=0.000000000000000E+00 beta (00000369)=0.125630517221873E+02 gamma(00000369)=0.125630517221873E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 369 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000369)=0.000000000000000E+00 beta (00000370)=0.133686469090770E+02 gamma(00000370)=0.133686469090770E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 370 z1= 1 -.212475843090927E-02 0.000000000000000E+00 z1= 2 0.304561701648318E-07 0.000000000000000E+00 z1= 3 0.383075648082104E-06 0.000000000000000E+00 alpha(00000370)=0.000000000000000E+00 beta (00000371)=0.128831600965838E+02 gamma(00000371)=0.128831600965838E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 371 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000371)=0.000000000000000E+00 beta (00000372)=0.133106375941712E+02 gamma(00000372)=0.133106375941712E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 372 z1= 1 0.214624319759468E-02 0.000000000000000E+00 z1= 2 -.344256279342578E-07 0.000000000000000E+00 z1= 3 -.391338272939475E-06 0.000000000000000E+00 alpha(00000372)=0.000000000000000E+00 beta (00000373)=0.128996778706195E+02 gamma(00000373)=0.128996778706195E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 373 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000373)=0.000000000000000E+00 beta (00000374)=0.136447959172799E+02 gamma(00000374)=0.136447959172799E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 374 z1= 1 -.207010835283262E-02 0.000000000000000E+00 z1= 2 0.255419940697020E-07 0.000000000000000E+00 z1= 3 0.390513972073087E-06 0.000000000000000E+00 alpha(00000374)=0.000000000000000E+00 beta (00000375)=0.128464970114019E+02 gamma(00000375)=0.128464970114019E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 375 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000375)=0.000000000000000E+00 beta (00000376)=0.131826068714331E+02 gamma(00000376)=0.131826068714331E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 376 z1= 1 0.196683188064460E-02 0.000000000000000E+00 z1= 2 -.264637751144249E-07 0.000000000000000E+00 z1= 3 -.407818345422471E-06 0.000000000000000E+00 alpha(00000376)=0.000000000000000E+00 beta (00000377)=0.130309435342255E+02 gamma(00000377)=0.130309435342255E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 377 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000377)=0.000000000000000E+00 beta (00000378)=0.135757048423205E+02 gamma(00000378)=0.135757048423205E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 378 z1= 1 -.175902142299706E-02 0.000000000000000E+00 z1= 2 0.173744983704080E-07 0.000000000000000E+00 z1= 3 0.421130900930762E-06 0.000000000000000E+00 alpha(00000378)=0.000000000000000E+00 beta (00000379)=0.125827936554666E+02 gamma(00000379)=0.125827936554666E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 379 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000379)=0.000000000000000E+00 beta (00000380)=0.133811895995919E+02 gamma(00000380)=0.133811895995919E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 380 z1= 1 0.146859639241393E-02 0.000000000000000E+00 z1= 2 -.210608065379786E-07 0.000000000000000E+00 z1= 3 -.428547522126219E-06 0.000000000000000E+00 alpha(00000380)=0.000000000000000E+00 beta (00000381)=0.131036682082295E+02 gamma(00000381)=0.131036682082295E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 381 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000381)=0.000000000000000E+00 beta (00000382)=0.134412103679244E+02 gamma(00000382)=0.134412103679244E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 382 z1= 1 -.127640601149869E-02 0.000000000000000E+00 z1= 2 0.183146695057965E-07 0.000000000000000E+00 z1= 3 0.446929912852398E-06 0.000000000000000E+00 alpha(00000382)=0.000000000000000E+00 beta (00000383)=0.129348310791855E+02 gamma(00000383)=0.129348310791855E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 383 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000383)=0.000000000000000E+00 beta (00000384)=0.134947083450352E+02 gamma(00000384)=0.134947083450352E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 384 z1= 1 0.111015967172054E-02 0.000000000000000E+00 z1= 2 -.236540670089241E-07 0.000000000000000E+00 z1= 3 -.459446008790085E-06 0.000000000000000E+00 alpha(00000384)=0.000000000000000E+00 beta (00000385)=0.126540228675919E+02 gamma(00000385)=0.126540228675919E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 385 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000385)=0.000000000000000E+00 beta (00000386)=0.130168214032631E+02 gamma(00000386)=0.130168214032631E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 386 z1= 1 -.966846323944714E-03 0.000000000000000E+00 z1= 2 0.240880439796032E-07 0.000000000000000E+00 z1= 3 0.473371102288094E-06 0.000000000000000E+00 alpha(00000386)=0.000000000000000E+00 beta (00000387)=0.129056948803937E+02 gamma(00000387)=0.129056948803937E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 387 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000387)=0.000000000000000E+00 beta (00000388)=0.133581500907726E+02 gamma(00000388)=0.133581500907726E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 388 z1= 1 0.838077402962626E-03 0.000000000000000E+00 z1= 2 -.290910402846005E-07 0.000000000000000E+00 z1= 3 -.478552960422017E-06 0.000000000000000E+00 alpha(00000388)=0.000000000000000E+00 beta (00000389)=0.125856372156396E+02 gamma(00000389)=0.125856372156396E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 389 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000389)=0.000000000000000E+00 beta (00000390)=0.134758448985142E+02 gamma(00000390)=0.134758448985142E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 390 z1= 1 -.729847489343701E-03 0.000000000000000E+00 z1= 2 0.270813289996244E-07 0.000000000000000E+00 z1= 3 0.472280897834186E-06 0.000000000000000E+00 alpha(00000390)=0.000000000000000E+00 beta (00000391)=0.129065526391147E+02 gamma(00000391)=0.129065526391147E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 391 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000391)=0.000000000000000E+00 beta (00000392)=0.131956492036556E+02 gamma(00000392)=0.131956492036556E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 392 z1= 1 0.744169571529956E-03 0.000000000000000E+00 z1= 2 -.309628149660311E-07 0.000000000000000E+00 z1= 3 -.490929019342321E-06 0.000000000000000E+00 alpha(00000392)=0.000000000000000E+00 beta (00000393)=0.126539182758723E+02 gamma(00000393)=0.126539182758723E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 393 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000393)=0.000000000000000E+00 beta (00000394)=0.133844470327565E+02 gamma(00000394)=0.133844470327565E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 394 z1= 1 -.721127177669995E-03 0.000000000000000E+00 z1= 2 0.303380949251419E-07 0.000000000000000E+00 z1= 3 0.489973156910851E-06 0.000000000000000E+00 alpha(00000394)=0.000000000000000E+00 beta (00000395)=0.126879520017255E+02 gamma(00000395)=0.126879520017255E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 395 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000395)=0.000000000000000E+00 beta (00000396)=0.132038457941862E+02 gamma(00000396)=0.132038457941862E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 396 z1= 1 0.632845794284158E-03 0.000000000000000E+00 z1= 2 -.330028987680087E-07 0.000000000000000E+00 z1= 3 -.490778044646238E-06 0.000000000000000E+00 alpha(00000396)=0.000000000000000E+00 beta (00000397)=0.127102183547790E+02 gamma(00000397)=0.127102183547790E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 397 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000397)=0.000000000000000E+00 beta (00000398)=0.131584532712332E+02 gamma(00000398)=0.131584532712332E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 398 z1= 1 -.428775341551707E-03 0.000000000000000E+00 z1= 2 0.371697523814628E-07 0.000000000000000E+00 z1= 3 0.499659210756670E-06 0.000000000000000E+00 alpha(00000398)=0.000000000000000E+00 beta (00000399)=0.126871726973744E+02 gamma(00000399)=0.126871726973744E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 399 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000399)=0.000000000000000E+00 beta (00000400)=0.136082791985577E+02 gamma(00000400)=0.136082791985577E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 400 z1= 1 0.187591704668943E-03 0.000000000000000E+00 z1= 2 -.372357666835604E-07 0.000000000000000E+00 z1= 3 -.487335180197586E-06 0.000000000000000E+00 alpha(00000400)=0.000000000000000E+00 beta (00000401)=0.128724917212147E+02 gamma(00000401)=0.128724917212147E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 401 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000401)=0.000000000000000E+00 beta (00000402)=0.132282194454744E+02 gamma(00000402)=0.132282194454744E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 402 z1= 1 0.859166357700977E-04 0.000000000000000E+00 z1= 2 0.374805351841673E-07 0.000000000000000E+00 z1= 3 0.497711565364213E-06 0.000000000000000E+00 alpha(00000402)=0.000000000000000E+00 beta (00000403)=0.129669921524757E+02 gamma(00000403)=0.129669921524757E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 403 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000403)=0.000000000000000E+00 beta (00000404)=0.133474505233169E+02 gamma(00000404)=0.133474505233169E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 404 z1= 1 -.282952444499811E-03 0.000000000000000E+00 z1= 2 -.347180883805264E-07 0.000000000000000E+00 z1= 3 -.506031888321680E-06 0.000000000000000E+00 alpha(00000404)=0.000000000000000E+00 beta (00000405)=0.126597764303263E+02 gamma(00000405)=0.126597764303263E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 405 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000405)=0.000000000000000E+00 beta (00000406)=0.135479217638861E+02 gamma(00000406)=0.135479217638861E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 406 z1= 1 0.447890065690466E-03 0.000000000000000E+00 z1= 2 0.350805231098903E-07 0.000000000000000E+00 z1= 3 0.498752990186216E-06 0.000000000000000E+00 alpha(00000406)=0.000000000000000E+00 beta (00000407)=0.127122162524345E+02 gamma(00000407)=0.127122162524345E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 407 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000407)=0.000000000000000E+00 beta (00000408)=0.130765072963832E+02 gamma(00000408)=0.130765072963832E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 408 z1= 1 -.688692684222166E-03 0.000000000000000E+00 z1= 2 -.324991742315338E-07 0.000000000000000E+00 z1= 3 -.507679302880941E-06 0.000000000000000E+00 alpha(00000408)=0.000000000000000E+00 beta (00000409)=0.129438317772918E+02 gamma(00000409)=0.129438317772918E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 409 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000409)=0.000000000000000E+00 beta (00000410)=0.133585496997682E+02 gamma(00000410)=0.133585496997682E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 410 z1= 1 0.928759526936192E-03 0.000000000000000E+00 z1= 2 0.345167081843706E-07 0.000000000000000E+00 z1= 3 0.520856609096537E-06 0.000000000000000E+00 alpha(00000410)=0.000000000000000E+00 beta (00000411)=0.128082036927253E+02 gamma(00000411)=0.128082036927253E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 411 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000411)=0.000000000000000E+00 beta (00000412)=0.138151170706388E+02 gamma(00000412)=0.138151170706388E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 412 z1= 1 -.106258138109473E-02 0.000000000000000E+00 z1= 2 -.344073924503883E-07 0.000000000000000E+00 z1= 3 -.506106129433853E-06 0.000000000000000E+00 alpha(00000412)=0.000000000000000E+00 beta (00000413)=0.124503914697000E+02 gamma(00000413)=0.124503914697000E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 413 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000413)=0.000000000000000E+00 beta (00000414)=0.133781968398271E+02 gamma(00000414)=0.133781968398271E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 414 z1= 1 0.111328558186396E-02 0.000000000000000E+00 z1= 2 0.378606952087211E-07 0.000000000000000E+00 z1= 3 0.497948832370982E-06 0.000000000000000E+00 alpha(00000414)=0.000000000000000E+00 beta (00000415)=0.130602896029097E+02 gamma(00000415)=0.130602896029097E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 415 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000415)=0.000000000000000E+00 beta (00000416)=0.135240134466582E+02 gamma(00000416)=0.135240134466582E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 416 z1= 1 -.106470264869577E-02 0.000000000000000E+00 z1= 2 -.363067383588045E-07 0.000000000000000E+00 z1= 3 -.501590762583357E-06 0.000000000000000E+00 alpha(00000416)=0.000000000000000E+00 beta (00000417)=0.126267848745057E+02 gamma(00000417)=0.126267848745057E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 417 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000417)=0.000000000000000E+00 beta (00000418)=0.138149855917553E+02 gamma(00000418)=0.138149855917553E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 418 z1= 1 0.854489496925412E-03 0.000000000000000E+00 z1= 2 0.392212314110837E-07 0.000000000000000E+00 z1= 3 0.485338930938429E-06 0.000000000000000E+00 alpha(00000418)=0.000000000000000E+00 beta (00000419)=0.126628280366595E+02 gamma(00000419)=0.126628280366595E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 419 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000419)=0.000000000000000E+00 beta (00000420)=0.135328842949049E+02 gamma(00000420)=0.135328842949049E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 420 z1= 1 -.678561717333175E-03 0.000000000000000E+00 z1= 2 -.389947677368815E-07 0.000000000000000E+00 z1= 3 -.477238183592291E-06 0.000000000000000E+00 alpha(00000420)=0.000000000000000E+00 beta (00000421)=0.128435859191782E+02 gamma(00000421)=0.128435859191782E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 421 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000421)=0.000000000000000E+00 beta (00000422)=0.130976992652625E+02 gamma(00000422)=0.130976992652625E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 422 z1= 1 0.619979710122382E-03 0.000000000000000E+00 z1= 2 0.447890095801526E-07 0.000000000000000E+00 z1= 3 0.497638896099781E-06 0.000000000000000E+00 alpha(00000422)=0.000000000000000E+00 beta (00000423)=0.127549532568655E+02 gamma(00000423)=0.127549532568655E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 423 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000423)=0.000000000000000E+00 beta (00000424)=0.136021896736702E+02 gamma(00000424)=0.136021896736702E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 424 z1= 1 -.545781670885814E-03 0.000000000000000E+00 z1= 2 -.406758444183863E-07 0.000000000000000E+00 z1= 3 -.492268457695033E-06 0.000000000000000E+00 alpha(00000424)=0.000000000000000E+00 beta (00000425)=0.123516468590891E+02 gamma(00000425)=0.123516468590891E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 425 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000425)=0.000000000000000E+00 beta (00000426)=0.137420394717425E+02 gamma(00000426)=0.137420394717425E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 426 z1= 1 0.419966111799891E-03 0.000000000000000E+00 z1= 2 0.398152955687590E-07 0.000000000000000E+00 z1= 3 0.473566131931231E-06 0.000000000000000E+00 alpha(00000426)=0.000000000000000E+00 beta (00000427)=0.127422154040728E+02 gamma(00000427)=0.127422154040728E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 427 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000427)=0.000000000000000E+00 beta (00000428)=0.133036721956106E+02 gamma(00000428)=0.133036721956106E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 428 z1= 1 -.210585489473326E-03 0.000000000000000E+00 z1= 2 -.359100894796981E-07 0.000000000000000E+00 z1= 3 -.483956272683776E-06 0.000000000000000E+00 alpha(00000428)=0.000000000000000E+00 beta (00000429)=0.128359407352579E+02 gamma(00000429)=0.128359407352579E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 429 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000429)=0.000000000000000E+00 beta (00000430)=0.132090865931353E+02 gamma(00000430)=0.132090865931353E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 430 z1= 1 -.143467726335032E-03 0.000000000000000E+00 z1= 2 0.352968552949119E-07 0.000000000000000E+00 z1= 3 0.495941424602650E-06 0.000000000000000E+00 alpha(00000430)=0.000000000000000E+00 beta (00000431)=0.129466047337215E+02 gamma(00000431)=0.129466047337215E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 431 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000431)=0.000000000000000E+00 beta (00000432)=0.135200582332563E+02 gamma(00000432)=0.135200582332563E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 432 z1= 1 0.471630985450437E-03 0.000000000000000E+00 z1= 2 -.331600072543854E-07 0.000000000000000E+00 z1= 3 -.494820313269324E-06 0.000000000000000E+00 alpha(00000432)=0.000000000000000E+00 beta (00000433)=0.125894269665727E+02 gamma(00000433)=0.125894269665727E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 433 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000433)=0.000000000000000E+00 beta (00000434)=0.137829706079164E+02 gamma(00000434)=0.137829706079164E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 434 z1= 1 -.700701733273584E-03 0.000000000000000E+00 z1= 2 0.323607657376664E-07 0.000000000000000E+00 z1= 3 0.478494313138535E-06 0.000000000000000E+00 alpha(00000434)=0.000000000000000E+00 beta (00000435)=0.128853813048934E+02 gamma(00000435)=0.128853813048934E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 435 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000435)=0.000000000000000E+00 beta (00000436)=0.132258469182081E+02 gamma(00000436)=0.132258469182081E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 436 z1= 1 0.901032009476175E-03 0.000000000000000E+00 z1= 2 -.339290706845123E-07 0.000000000000000E+00 z1= 3 -.500650126559424E-06 0.000000000000000E+00 alpha(00000436)=0.000000000000000E+00 beta (00000437)=0.129075885881246E+02 gamma(00000437)=0.129075885881246E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 437 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000437)=0.000000000000000E+00 beta (00000438)=0.128552983526688E+02 gamma(00000438)=0.128552983526688E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 438 z1= 1 -.935134636740222E-03 0.000000000000000E+00 z1= 2 0.369391173345949E-07 0.000000000000000E+00 z1= 3 0.536920562260734E-06 0.000000000000000E+00 alpha(00000438)=0.000000000000000E+00 beta (00000439)=0.127812156796169E+02 gamma(00000439)=0.127812156796169E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 439 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000439)=0.000000000000000E+00 beta (00000440)=0.133198565664581E+02 gamma(00000440)=0.133198565664581E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 440 z1= 1 0.809275524487015E-03 0.000000000000000E+00 z1= 2 -.392900610715879E-07 0.000000000000000E+00 z1= 3 -.546728428546788E-06 0.000000000000000E+00 alpha(00000440)=0.000000000000000E+00 beta (00000441)=0.124650117977104E+02 gamma(00000441)=0.124650117977104E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 441 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000441)=0.000000000000000E+00 beta (00000442)=0.134801116367154E+02 gamma(00000442)=0.134801116367154E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 442 z1= 1 -.514588900754214E-03 0.000000000000000E+00 z1= 2 0.424828545042208E-07 0.000000000000000E+00 z1= 3 0.538369148083643E-06 0.000000000000000E+00 alpha(00000442)=0.000000000000000E+00 beta (00000443)=0.125914939942751E+02 gamma(00000443)=0.125914939942751E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 443 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000443)=0.000000000000000E+00 beta (00000444)=0.133360288916622E+02 gamma(00000444)=0.133360288916622E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 444 z1= 1 0.178375667044202E-03 0.000000000000000E+00 z1= 2 -.427656740155206E-07 0.000000000000000E+00 z1= 3 -.541758708663340E-06 0.000000000000000E+00 alpha(00000444)=0.000000000000000E+00 beta (00000445)=0.132106438385670E+02 gamma(00000445)=0.132106438385670E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 445 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000445)=0.000000000000000E+00 beta (00000446)=0.130293023441064E+02 gamma(00000446)=0.130293023441064E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 446 z1= 1 0.132390146586336E-03 0.000000000000000E+00 z1= 2 0.450402568154089E-07 0.000000000000000E+00 z1= 3 0.575528379049119E-06 0.000000000000000E+00 alpha(00000446)=0.000000000000000E+00 beta (00000447)=0.129510242074914E+02 gamma(00000447)=0.129510242074914E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 447 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000447)=0.000000000000000E+00 beta (00000448)=0.132109984721176E+02 gamma(00000448)=0.132109984721176E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 448 z1= 1 -.346148370424944E-03 0.000000000000000E+00 z1= 2 -.443138366739218E-07 0.000000000000000E+00 z1= 3 -.592754616193097E-06 0.000000000000000E+00 alpha(00000448)=0.000000000000000E+00 beta (00000449)=0.129466928959812E+02 gamma(00000449)=0.129466928959812E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 449 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000449)=0.000000000000000E+00 beta (00000450)=0.136530008039211E+02 gamma(00000450)=0.136530008039211E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 450 z1= 1 0.464364874070565E-03 0.000000000000000E+00 z1= 2 0.449495745763473E-07 0.000000000000000E+00 z1= 3 0.590541930138317E-06 0.000000000000000E+00 alpha(00000450)=0.000000000000000E+00 beta (00000451)=0.124487286675448E+02 gamma(00000451)=0.124487286675448E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 451 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000451)=0.000000000000000E+00 beta (00000452)=0.137444282335480E+02 gamma(00000452)=0.137444282335480E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 452 z1= 1 -.623580812266581E-03 0.000000000000000E+00 z1= 2 -.487091326387828E-07 0.000000000000000E+00 z1= 3 -.565534696450641E-06 0.000000000000000E+00 alpha(00000452)=0.000000000000000E+00 beta (00000453)=0.123492792943336E+02 gamma(00000453)=0.123492792943336E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 453 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000453)=0.000000000000000E+00 beta (00000454)=0.136339924296051E+02 gamma(00000454)=0.136339924296051E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 454 z1= 1 0.742635107951315E-03 0.000000000000000E+00 z1= 2 0.555134349296618E-07 0.000000000000000E+00 z1= 3 0.548748090167459E-06 0.000000000000000E+00 alpha(00000454)=0.000000000000000E+00 beta (00000455)=0.124956422855072E+02 gamma(00000455)=0.124956422855072E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 455 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000455)=0.000000000000000E+00 beta (00000456)=0.136121477381506E+02 gamma(00000456)=0.136121477381506E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 456 z1= 1 -.938371587880795E-03 0.000000000000000E+00 z1= 2 -.665335620386905E-07 0.000000000000000E+00 z1= 3 -.544135683317772E-06 0.000000000000000E+00 alpha(00000456)=0.000000000000000E+00 beta (00000457)=0.127309849063334E+02 gamma(00000457)=0.127309849063334E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 457 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000457)=0.000000000000000E+00 beta (00000458)=0.134655821146850E+02 gamma(00000458)=0.134655821146850E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 458 z1= 1 0.110848604804663E-02 0.000000000000000E+00 z1= 2 0.697746285228951E-07 0.000000000000000E+00 z1= 3 0.553887292810548E-06 0.000000000000000E+00 alpha(00000458)=0.000000000000000E+00 beta (00000459)=0.129367218073465E+02 gamma(00000459)=0.129367218073465E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 459 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000459)=0.000000000000000E+00 beta (00000460)=0.134363999881314E+02 gamma(00000460)=0.134363999881314E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 460 z1= 1 -.121737282876096E-02 0.000000000000000E+00 z1= 2 -.746851671644053E-07 0.000000000000000E+00 z1= 3 -.568512922527475E-06 0.000000000000000E+00 alpha(00000460)=0.000000000000000E+00 beta (00000461)=0.127154405081115E+02 gamma(00000461)=0.127154405081115E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 461 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000461)=0.000000000000000E+00 beta (00000462)=0.133070827920411E+02 gamma(00000462)=0.133070827920411E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 462 z1= 1 0.123502995967969E-02 0.000000000000000E+00 z1= 2 0.696839088966394E-07 0.000000000000000E+00 z1= 3 0.574752815746683E-06 0.000000000000000E+00 alpha(00000462)=0.000000000000000E+00 beta (00000463)=0.130283951462525E+02 gamma(00000463)=0.130283951462525E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 463 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000463)=0.000000000000000E+00 beta (00000464)=0.134222255164598E+02 gamma(00000464)=0.134222255164598E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 464 z1= 1 -.114392807147325E-02 0.000000000000000E+00 z1= 2 -.740293188790028E-07 0.000000000000000E+00 z1= 3 -.593064672808463E-06 0.000000000000000E+00 alpha(00000464)=0.000000000000000E+00 beta (00000465)=0.126548174488071E+02 gamma(00000465)=0.126548174488071E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 465 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000465)=0.000000000000000E+00 beta (00000466)=0.134462829795422E+02 gamma(00000466)=0.134462829795422E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 466 z1= 1 0.998942681777454E-03 0.000000000000000E+00 z1= 2 0.707334460222503E-07 0.000000000000000E+00 z1= 3 0.590874711461757E-06 0.000000000000000E+00 alpha(00000466)=0.000000000000000E+00 beta (00000467)=0.128133594885047E+02 gamma(00000467)=0.128133594885047E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 467 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000467)=0.000000000000000E+00 beta (00000468)=0.136879995993932E+02 gamma(00000468)=0.136879995993932E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 468 z1= 1 -.835319235754500E-03 0.000000000000000E+00 z1= 2 -.708981222029281E-07 0.000000000000000E+00 z1= 3 -.588857381482910E-06 0.000000000000000E+00 alpha(00000468)=0.000000000000000E+00 beta (00000469)=0.126931042731059E+02 gamma(00000469)=0.126931042731059E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 469 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000469)=0.000000000000000E+00 beta (00000470)=0.136809104579998E+02 gamma(00000470)=0.136809104579998E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 470 z1= 1 0.600305333397883E-03 0.000000000000000E+00 z1= 2 0.587164255445860E-07 0.000000000000000E+00 z1= 3 0.580511261588212E-06 0.000000000000000E+00 alpha(00000470)=0.000000000000000E+00 beta (00000471)=0.127568981227507E+02 gamma(00000471)=0.127568981227507E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 471 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000471)=0.000000000000000E+00 beta (00000472)=0.133840182062357E+02 gamma(00000472)=0.133840182062357E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 472 z1= 1 -.373829705644623E-03 0.000000000000000E+00 z1= 2 -.579006448654662E-07 0.000000000000000E+00 z1= 3 -.587150886898489E-06 0.000000000000000E+00 alpha(00000472)=0.000000000000000E+00 beta (00000473)=0.126367612249266E+02 gamma(00000473)=0.126367612249266E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 473 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000473)=0.000000000000000E+00 beta (00000474)=0.134963115797283E+02 gamma(00000474)=0.134963115797283E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 474 z1= 1 0.135699328521990E-03 0.000000000000000E+00 z1= 2 0.530314028810222E-07 0.000000000000000E+00 z1= 3 0.578809841588097E-06 0.000000000000000E+00 alpha(00000474)=0.000000000000000E+00 beta (00000475)=0.127396972830248E+02 gamma(00000475)=0.127396972830248E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 475 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000475)=0.000000000000000E+00 beta (00000476)=0.133045811407380E+02 gamma(00000476)=0.133045811407380E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 476 z1= 1 -.949521504158089E-06 0.000000000000000E+00 z1= 2 -.562650530212122E-07 0.000000000000000E+00 z1= 3 -.589178637991176E-06 0.000000000000000E+00 alpha(00000476)=0.000000000000000E+00 beta (00000477)=0.126413678526527E+02 gamma(00000477)=0.126413678526527E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 477 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000477)=0.000000000000000E+00 beta (00000478)=0.133309751278247E+02 gamma(00000478)=0.133309751278247E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 478 z1= 1 -.917928804126120E-04 0.000000000000000E+00 z1= 2 0.600280680145698E-07 0.000000000000000E+00 z1= 3 0.597298193202520E-06 0.000000000000000E+00 alpha(00000478)=0.000000000000000E+00 beta (00000479)=0.126278807634763E+02 gamma(00000479)=0.126278807634763E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 479 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000479)=0.000000000000000E+00 beta (00000480)=0.133938909197711E+02 gamma(00000480)=0.133938909197711E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 480 z1= 1 0.173564655931108E-03 0.000000000000000E+00 z1= 2 -.595572097290484E-07 0.000000000000000E+00 z1= 3 -.607327192350053E-06 0.000000000000000E+00 alpha(00000480)=0.000000000000000E+00 beta (00000481)=0.126436592606431E+02 gamma(00000481)=0.126436592606431E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 481 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000481)=0.000000000000000E+00 beta (00000482)=0.134765935160756E+02 gamma(00000482)=0.134765935160756E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 482 z1= 1 -.277317624674114E-03 0.000000000000000E+00 z1= 2 0.567867193797603E-07 0.000000000000000E+00 z1= 3 0.612593675391765E-06 0.000000000000000E+00 alpha(00000482)=0.000000000000000E+00 beta (00000483)=0.127038191404440E+02 gamma(00000483)=0.127038191404440E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 483 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000483)=0.000000000000000E+00 beta (00000484)=0.136555924060178E+02 gamma(00000484)=0.136555924060178E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 484 z1= 1 0.375817960144111E-03 0.000000000000000E+00 z1= 2 -.509772709665450E-07 0.000000000000000E+00 z1= 3 -.608729847991591E-06 0.000000000000000E+00 alpha(00000484)=0.000000000000000E+00 beta (00000485)=0.126726827735567E+02 gamma(00000485)=0.126726827735567E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 485 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000485)=0.000000000000000E+00 beta (00000486)=0.132370700613873E+02 gamma(00000486)=0.132370700613873E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 486 z1= 1 -.479675316167138E-03 0.000000000000000E+00 z1= 2 0.459732578919798E-07 0.000000000000000E+00 z1= 3 0.620532457364770E-06 0.000000000000000E+00 alpha(00000486)=0.000000000000000E+00 beta (00000487)=0.124437822492099E+02 gamma(00000487)=0.124437822492099E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 487 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000487)=0.000000000000000E+00 beta (00000488)=0.134506488257847E+02 gamma(00000488)=0.134506488257847E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 488 z1= 1 0.509273305682624E-03 0.000000000000000E+00 z1= 2 -.445064254235572E-07 0.000000000000000E+00 z1= 3 -.618326904969755E-06 0.000000000000000E+00 alpha(00000488)=0.000000000000000E+00 beta (00000489)=0.128388999083738E+02 gamma(00000489)=0.128388999083738E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 489 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000489)=0.000000000000000E+00 beta (00000490)=0.132662142286047E+02 gamma(00000490)=0.132662142286047E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 490 z1= 1 -.578700451313097E-03 0.000000000000000E+00 z1= 2 0.488806722724090E-07 0.000000000000000E+00 z1= 3 0.644351635951642E-06 0.000000000000000E+00 alpha(00000490)=0.000000000000000E+00 beta (00000491)=0.125996013707022E+02 gamma(00000491)=0.125996013707022E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 491 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000491)=0.000000000000000E+00 beta (00000492)=0.134509561923446E+02 gamma(00000492)=0.134509561923446E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 492 z1= 1 0.651035750352896E-03 0.000000000000000E+00 z1= 2 -.472962513014662E-07 0.000000000000000E+00 z1= 3 -.649967412285100E-06 0.000000000000000E+00 alpha(00000492)=0.000000000000000E+00 beta (00000493)=0.127244129466738E+02 gamma(00000493)=0.127244129466738E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 493 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000493)=0.000000000000000E+00 beta (00000494)=0.132869518567009E+02 gamma(00000494)=0.132869518567009E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 494 z1= 1 -.800550372940768E-03 0.000000000000000E+00 z1= 2 0.562421501077055E-07 0.000000000000000E+00 z1= 3 0.667780432365311E-06 0.000000000000000E+00 alpha(00000494)=0.000000000000000E+00 beta (00000495)=0.124536269577275E+02 gamma(00000495)=0.124536269577275E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 495 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000495)=0.000000000000000E+00 beta (00000496)=0.134976843065893E+02 gamma(00000496)=0.134976843065893E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 496 z1= 1 0.850560317069670E-03 0.000000000000000E+00 z1= 2 -.572096161134510E-07 0.000000000000000E+00 z1= 3 -.667485505766977E-06 0.000000000000000E+00 alpha(00000496)=0.000000000000000E+00 beta (00000497)=0.128392363155870E+02 gamma(00000497)=0.128392363155870E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 497 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000497)=0.000000000000000E+00 beta (00000498)=0.133354135195453E+02 gamma(00000498)=0.133354135195453E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 498 z1= 1 -.921242262406430E-03 0.000000000000000E+00 z1= 2 0.725230895675874E-07 0.000000000000000E+00 z1= 3 0.693492468480778E-06 0.000000000000000E+00 alpha(00000498)=0.000000000000000E+00 beta (00000499)=0.126817399847036E+02 gamma(00000499)=0.126817399847036E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 499 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000499)=0.000000000000000E+00 beta (00000500)=0.134574860828990E+02 gamma(00000500)=0.134574860828990E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 500 z1= 1 0.105538487098658E-02 0.000000000000000E+00 z1= 2 -.655256861912396E-07 0.000000000000000E+00 z1= 3 -.702838314706167E-06 0.000000000000000E+00 alpha(00000500)=0.000000000000000E+00 beta (00000501)=0.127050045484999E+02 gamma(00000501)=0.127050045484999E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Norm of initial Lanczos vectors= 1.841314849862906 Starting Lanczos loop 2 Lanczos iteration: 1 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal alpha(00000001)=0.000000000000000E+00 beta (00000002)=0.172013906916120E+01 gamma(00000002)=0.172013906916120E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 2 z1= 1 0.172110041709791E-06 0.000000000000000E+00 z1= 2 0.124507708939105E+01 0.000000000000000E+00 z1= 3 -.139126227913342E-06 0.000000000000000E+00 alpha(00000002)=0.000000000000000E+00 beta (00000003)=0.476624633735415E+01 gamma(00000003)=0.476624633735415E+01 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 3 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000003)=0.000000000000000E+00 beta (00000004)=0.135459703997528E+02 gamma(00000004)=0.135459703997528E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 4 z1= 1 -.533571112874484E-07 0.000000000000000E+00 z1= 2 -.355851008692851E+00 0.000000000000000E+00 z1= 3 0.490862761687102E-07 0.000000000000000E+00 alpha(00000004)=0.000000000000000E+00 beta (00000005)=0.127188528805149E+02 gamma(00000005)=0.127188528805149E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 5 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000005)=0.000000000000000E+00 beta (00000006)=0.134777618868894E+02 gamma(00000006)=0.134777618868894E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 6 z1= 1 0.489257136553588E-07 0.000000000000000E+00 z1= 2 0.303388625836486E+00 0.000000000000000E+00 z1= 3 -.461991684099403E-07 0.000000000000000E+00 alpha(00000006)=0.000000000000000E+00 beta (00000007)=0.128882512117880E+02 gamma(00000007)=0.128882512117880E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 7 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000007)=0.000000000000000E+00 beta (00000008)=0.133738502268442E+02 gamma(00000008)=0.133738502268442E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 8 z1= 1 -.458281354878687E-07 0.000000000000000E+00 z1= 2 -.273843952495674E+00 0.000000000000000E+00 z1= 3 0.495802739435458E-07 0.000000000000000E+00 alpha(00000008)=0.000000000000000E+00 beta (00000009)=0.128589254709051E+02 gamma(00000009)=0.128589254709051E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 9 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000009)=0.000000000000000E+00 beta (00000010)=0.134144080326914E+02 gamma(00000010)=0.134144080326914E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 10 z1= 1 0.449034478554149E-07 0.000000000000000E+00 z1= 2 0.250112103788913E+00 0.000000000000000E+00 z1= 3 -.548025188605659E-07 0.000000000000000E+00 alpha(00000010)=0.000000000000000E+00 beta (00000011)=0.128243160048417E+02 gamma(00000011)=0.128243160048417E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 11 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000011)=0.000000000000000E+00 beta (00000012)=0.134765065572765E+02 gamma(00000012)=0.134765065572765E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 12 z1= 1 -.481529143360297E-07 0.000000000000000E+00 z1= 2 -.228509388587741E+00 0.000000000000000E+00 z1= 3 0.581884307638766E-07 0.000000000000000E+00 alpha(00000012)=0.000000000000000E+00 beta (00000013)=0.128064926804123E+02 gamma(00000013)=0.128064926804123E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 13 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000013)=0.000000000000000E+00 beta (00000014)=0.134984094991496E+02 gamma(00000014)=0.134984094991496E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 14 z1= 1 0.527885775404580E-07 0.000000000000000E+00 z1= 2 0.209127934341773E+00 0.000000000000000E+00 z1= 3 -.612587533461133E-07 0.000000000000000E+00 alpha(00000014)=0.000000000000000E+00 beta (00000015)=0.128005627510450E+02 gamma(00000015)=0.128005627510450E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 15 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000015)=0.000000000000000E+00 beta (00000016)=0.134717442121919E+02 gamma(00000016)=0.134717442121919E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 16 z1= 1 -.630250715258178E-07 0.000000000000000E+00 z1= 2 -.192248792391129E+00 0.000000000000000E+00 z1= 3 0.624142586956117E-07 0.000000000000000E+00 alpha(00000016)=0.000000000000000E+00 beta (00000017)=0.127887249145069E+02 gamma(00000017)=0.127887249145069E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 17 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000017)=0.000000000000000E+00 beta (00000018)=0.134268149509487E+02 gamma(00000018)=0.134268149509487E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 18 z1= 1 0.747901179581206E-07 0.000000000000000E+00 z1= 2 0.177640814349746E+00 0.000000000000000E+00 z1= 3 -.586223984492450E-07 0.000000000000000E+00 alpha(00000018)=0.000000000000000E+00 beta (00000019)=0.127825867293461E+02 gamma(00000019)=0.127825867293461E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 19 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000019)=0.000000000000000E+00 beta (00000020)=0.134082292550999E+02 gamma(00000020)=0.134082292550999E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 20 z1= 1 -.870504701152436E-07 0.000000000000000E+00 z1= 2 -.164659691259132E+00 0.000000000000000E+00 z1= 3 0.549535429524120E-07 0.000000000000000E+00 alpha(00000020)=0.000000000000000E+00 beta (00000021)=0.128007467695732E+02 gamma(00000021)=0.128007467695732E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 21 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000021)=0.000000000000000E+00 beta (00000022)=0.134209305900222E+02 gamma(00000022)=0.134209305900222E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 22 z1= 1 0.100268343200365E-06 0.000000000000000E+00 z1= 2 0.153026619098594E+00 0.000000000000000E+00 z1= 3 -.541056621210711E-07 0.000000000000000E+00 alpha(00000022)=0.000000000000000E+00 beta (00000023)=0.128225909343959E+02 gamma(00000023)=0.128225909343959E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 23 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000023)=0.000000000000000E+00 beta (00000024)=0.134334889541437E+02 gamma(00000024)=0.134334889541437E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 24 z1= 1 -.112789843667062E-06 0.000000000000000E+00 z1= 2 -.142608283539489E+00 0.000000000000000E+00 z1= 3 0.571304011214089E-07 0.000000000000000E+00 alpha(00000024)=0.000000000000000E+00 beta (00000025)=0.128311463605671E+02 gamma(00000025)=0.128311463605671E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 25 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000025)=0.000000000000000E+00 beta (00000026)=0.134385690807500E+02 gamma(00000026)=0.134385690807500E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 26 z1= 1 0.120719054276346E-06 0.000000000000000E+00 z1= 2 0.133154067106524E+00 0.000000000000000E+00 z1= 3 -.633168605243664E-07 0.000000000000000E+00 alpha(00000026)=0.000000000000000E+00 beta (00000027)=0.128182409262972E+02 gamma(00000027)=0.128182409262972E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 27 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000027)=0.000000000000000E+00 beta (00000028)=0.134104210151249E+02 gamma(00000028)=0.134104210151249E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 28 z1= 1 -.132276510464609E-06 0.000000000000000E+00 z1= 2 -.124654477424849E+00 0.000000000000000E+00 z1= 3 0.689102303038362E-07 0.000000000000000E+00 alpha(00000028)=0.000000000000000E+00 beta (00000029)=0.127846978458827E+02 gamma(00000029)=0.127846978458827E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 29 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000029)=0.000000000000000E+00 beta (00000030)=0.134136262688203E+02 gamma(00000030)=0.134136262688203E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 30 z1= 1 0.143096309079827E-06 0.000000000000000E+00 z1= 2 0.116502223767410E+00 0.000000000000000E+00 z1= 3 -.708415486351034E-07 0.000000000000000E+00 alpha(00000030)=0.000000000000000E+00 beta (00000031)=0.128191855000415E+02 gamma(00000031)=0.128191855000415E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 31 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000031)=0.000000000000000E+00 beta (00000032)=0.134296071460950E+02 gamma(00000032)=0.134296071460950E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 32 z1= 1 -.148555675661896E-06 0.000000000000000E+00 z1= 2 -.109172825999064E+00 0.000000000000000E+00 z1= 3 0.752909992264399E-07 0.000000000000000E+00 alpha(00000032)=0.000000000000000E+00 beta (00000033)=0.127671477436258E+02 gamma(00000033)=0.127671477436258E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 33 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000033)=0.000000000000000E+00 beta (00000034)=0.133588559607038E+02 gamma(00000034)=0.133588559607038E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 34 z1= 1 0.153166747175228E-06 0.000000000000000E+00 z1= 2 0.102503255022968E+00 0.000000000000000E+00 z1= 3 -.827053644649064E-07 0.000000000000000E+00 alpha(00000034)=0.000000000000000E+00 beta (00000035)=0.127703456300896E+02 gamma(00000035)=0.127703456300896E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 35 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000035)=0.000000000000000E+00 beta (00000036)=0.134313007985163E+02 gamma(00000036)=0.134313007985163E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 36 z1= 1 -.152381759537835E-06 0.000000000000000E+00 z1= 2 -.958077383774240E-01 0.000000000000000E+00 z1= 3 0.826117979522143E-07 0.000000000000000E+00 alpha(00000036)=0.000000000000000E+00 beta (00000037)=0.128060735180106E+02 gamma(00000037)=0.128060735180106E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 37 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000037)=0.000000000000000E+00 beta (00000038)=0.133890902896343E+02 gamma(00000038)=0.133890902896343E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 38 z1= 1 0.148173558565251E-06 0.000000000000000E+00 z1= 2 0.901244259230834E-01 0.000000000000000E+00 z1= 3 -.819607925583077E-07 0.000000000000000E+00 alpha(00000038)=0.000000000000000E+00 beta (00000039)=0.127549839057975E+02 gamma(00000039)=0.127549839057975E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 39 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000039)=0.000000000000000E+00 beta (00000040)=0.133499001837074E+02 gamma(00000040)=0.133499001837074E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 40 z1= 1 -.141579822559267E-06 0.000000000000000E+00 z1= 2 -.847130226410086E-01 0.000000000000000E+00 z1= 3 0.844656154747731E-07 0.000000000000000E+00 alpha(00000040)=0.000000000000000E+00 beta (00000041)=0.126995610158211E+02 gamma(00000041)=0.126995610158211E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 41 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000041)=0.000000000000000E+00 beta (00000042)=0.133248690928424E+02 gamma(00000042)=0.133248690928424E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 42 z1= 1 0.137409344553793E-06 0.000000000000000E+00 z1= 2 0.794237661069434E-01 0.000000000000000E+00 z1= 3 -.843410761876598E-07 0.000000000000000E+00 alpha(00000042)=0.000000000000000E+00 beta (00000043)=0.127528764992882E+02 gamma(00000043)=0.127528764992882E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 43 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000043)=0.000000000000000E+00 beta (00000044)=0.133693950178117E+02 gamma(00000044)=0.133693950178117E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 44 z1= 1 -.138171369059789E-06 0.000000000000000E+00 z1= 2 -.745707386306917E-01 0.000000000000000E+00 z1= 3 0.858010965871614E-07 0.000000000000000E+00 alpha(00000044)=0.000000000000000E+00 beta (00000045)=0.127653070624643E+02 gamma(00000045)=0.127653070624643E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 45 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000045)=0.000000000000000E+00 beta (00000046)=0.134074091631309E+02 gamma(00000046)=0.134074091631309E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 46 z1= 1 0.137853349184598E-06 0.000000000000000E+00 z1= 2 0.698759058429037E-01 0.000000000000000E+00 z1= 3 -.873798070399727E-07 0.000000000000000E+00 alpha(00000046)=0.000000000000000E+00 beta (00000047)=0.127671435994636E+02 gamma(00000047)=0.127671435994636E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 47 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000047)=0.000000000000000E+00 beta (00000048)=0.133559385124588E+02 gamma(00000048)=0.133559385124588E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 48 z1= 1 -.134250858831262E-06 0.000000000000000E+00 z1= 2 -.657379762770198E-01 0.000000000000000E+00 z1= 3 0.907093747977341E-07 0.000000000000000E+00 alpha(00000048)=0.000000000000000E+00 beta (00000049)=0.128436473216811E+02 gamma(00000049)=0.128436473216811E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 49 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000049)=0.000000000000000E+00 beta (00000050)=0.134360454928345E+02 gamma(00000050)=0.134360454928345E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 50 z1= 1 0.127833850424846E-06 0.000000000000000E+00 z1= 2 0.618983139005850E-01 0.000000000000000E+00 z1= 3 -.917963809810409E-07 0.000000000000000E+00 alpha(00000050)=0.000000000000000E+00 beta (00000051)=0.126967718233702E+02 gamma(00000051)=0.126967718233702E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 51 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000051)=0.000000000000000E+00 beta (00000052)=0.132892772197595E+02 gamma(00000052)=0.132892772197595E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 52 z1= 1 -.124011252687801E-06 0.000000000000000E+00 z1= 2 -.582039409690527E-01 0.000000000000000E+00 z1= 3 0.963838151283821E-07 0.000000000000000E+00 alpha(00000052)=0.000000000000000E+00 beta (00000053)=0.127443748198551E+02 gamma(00000053)=0.127443748198551E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 53 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000053)=0.000000000000000E+00 beta (00000054)=0.133133392531234E+02 gamma(00000054)=0.133133392531234E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 54 z1= 1 0.119556598670179E-06 0.000000000000000E+00 z1= 2 0.548828947596621E-01 0.000000000000000E+00 z1= 3 -.103184541670271E-06 0.000000000000000E+00 alpha(00000054)=0.000000000000000E+00 beta (00000055)=0.127443762556371E+02 gamma(00000055)=0.127443762556371E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 55 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000055)=0.000000000000000E+00 beta (00000056)=0.133787245091903E+02 gamma(00000056)=0.133787245091903E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 56 z1= 1 -.112055730898657E-06 0.000000000000000E+00 z1= 2 -.515188798870188E-01 0.000000000000000E+00 z1= 3 0.101853231864656E-06 0.000000000000000E+00 alpha(00000056)=0.000000000000000E+00 beta (00000057)=0.128320490056341E+02 gamma(00000057)=0.128320490056341E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 57 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000057)=0.000000000000000E+00 beta (00000058)=0.134462094546040E+02 gamma(00000058)=0.134462094546040E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 58 z1= 1 0.104674322561234E-06 0.000000000000000E+00 z1= 2 0.484468574046806E-01 0.000000000000000E+00 z1= 3 -.964781237027326E-07 0.000000000000000E+00 alpha(00000058)=0.000000000000000E+00 beta (00000059)=0.127464630668887E+02 gamma(00000059)=0.127464630668887E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 59 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000059)=0.000000000000000E+00 beta (00000060)=0.133329418461316E+02 gamma(00000060)=0.133329418461316E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 60 z1= 1 -.102711810370283E-06 0.000000000000000E+00 z1= 2 -.456812389729194E-01 0.000000000000000E+00 z1= 3 0.900649673511679E-07 0.000000000000000E+00 alpha(00000060)=0.000000000000000E+00 beta (00000061)=0.128406170968575E+02 gamma(00000061)=0.128406170968575E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 61 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000061)=0.000000000000000E+00 beta (00000062)=0.133762263355243E+02 gamma(00000062)=0.133762263355243E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 62 z1= 1 0.102324344304107E-06 0.000000000000000E+00 z1= 2 0.432498680627389E-01 0.000000000000000E+00 z1= 3 -.871495811025644E-07 0.000000000000000E+00 alpha(00000062)=0.000000000000000E+00 beta (00000063)=0.128441566514729E+02 gamma(00000063)=0.128441566514729E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 63 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000063)=0.000000000000000E+00 beta (00000064)=0.134461690218506E+02 gamma(00000064)=0.134461690218506E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 64 z1= 1 -.101791267649240E-06 0.000000000000000E+00 z1= 2 -.407854490477393E-01 0.000000000000000E+00 z1= 3 0.903002243447955E-07 0.000000000000000E+00 alpha(00000064)=0.000000000000000E+00 beta (00000065)=0.128237828330686E+02 gamma(00000065)=0.128237828330686E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 65 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000065)=0.000000000000000E+00 beta (00000066)=0.134806318472467E+02 gamma(00000066)=0.134806318472467E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 66 z1= 1 0.940292612071347E-07 0.000000000000000E+00 z1= 2 0.383379839676084E-01 0.000000000000000E+00 z1= 3 -.990754359385154E-07 0.000000000000000E+00 alpha(00000066)=0.000000000000000E+00 beta (00000067)=0.128621506018938E+02 gamma(00000067)=0.128621506018938E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 67 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000067)=0.000000000000000E+00 beta (00000068)=0.133883503610673E+02 gamma(00000068)=0.133883503610673E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 68 z1= 1 -.847736008977723E-07 0.000000000000000E+00 z1= 2 -.363901294539607E-01 0.000000000000000E+00 z1= 3 0.111782346838015E-06 0.000000000000000E+00 alpha(00000068)=0.000000000000000E+00 beta (00000069)=0.128153637531614E+02 gamma(00000069)=0.128153637531614E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 69 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000069)=0.000000000000000E+00 beta (00000070)=0.133446926096801E+02 gamma(00000070)=0.133446926096801E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 70 z1= 1 0.783140513454031E-07 0.000000000000000E+00 z1= 2 0.345609198558099E-01 0.000000000000000E+00 z1= 3 -.115960017874341E-06 0.000000000000000E+00 alpha(00000070)=0.000000000000000E+00 beta (00000071)=0.128069911990952E+02 gamma(00000071)=0.128069911990952E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 71 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000071)=0.000000000000000E+00 beta (00000072)=0.134044166019090E+02 gamma(00000072)=0.134044166019090E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 72 z1= 1 -.746973096395816E-07 0.000000000000000E+00 z1= 2 -.326774682484268E-01 0.000000000000000E+00 z1= 3 0.114630054235990E-06 0.000000000000000E+00 alpha(00000072)=0.000000000000000E+00 beta (00000073)=0.128627065314903E+02 gamma(00000073)=0.128627065314903E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 73 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000073)=0.000000000000000E+00 beta (00000074)=0.133233024192325E+02 gamma(00000074)=0.133233024192325E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 74 z1= 1 0.727308955852067E-07 0.000000000000000E+00 z1= 2 0.312847822724012E-01 0.000000000000000E+00 z1= 3 -.113838495597964E-06 0.000000000000000E+00 alpha(00000074)=0.000000000000000E+00 beta (00000075)=0.127141548023157E+02 gamma(00000075)=0.127141548023157E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 75 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000075)=0.000000000000000E+00 beta (00000076)=0.133871081198008E+02 gamma(00000076)=0.133871081198008E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 76 z1= 1 -.705120209300129E-07 0.000000000000000E+00 z1= 2 -.294455497931029E-01 0.000000000000000E+00 z1= 3 0.109511113476197E-06 0.000000000000000E+00 alpha(00000076)=0.000000000000000E+00 beta (00000077)=0.127642053168733E+02 gamma(00000077)=0.127642053168733E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 77 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000077)=0.000000000000000E+00 beta (00000078)=0.133756584704873E+02 gamma(00000078)=0.133756584704873E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 78 z1= 1 0.681821564910493E-07 0.000000000000000E+00 z1= 2 0.278574053675483E-01 0.000000000000000E+00 z1= 3 -.102938261307875E-06 0.000000000000000E+00 alpha(00000078)=0.000000000000000E+00 beta (00000079)=0.128263640433597E+02 gamma(00000079)=0.128263640433597E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 79 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000079)=0.000000000000000E+00 beta (00000080)=0.133318281539000E+02 gamma(00000080)=0.133318281539000E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 80 z1= 1 -.687390011577804E-07 0.000000000000000E+00 z1= 2 -.266395105983058E-01 0.000000000000000E+00 z1= 3 0.100582006478753E-06 0.000000000000000E+00 alpha(00000080)=0.000000000000000E+00 beta (00000081)=0.127857476641574E+02 gamma(00000081)=0.127857476641574E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 81 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000081)=0.000000000000000E+00 beta (00000082)=0.133996441523382E+02 gamma(00000082)=0.133996441523382E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 82 z1= 1 0.699292687957043E-07 0.000000000000000E+00 z1= 2 0.252906998675713E-01 0.000000000000000E+00 z1= 3 -.101213294716705E-06 0.000000000000000E+00 alpha(00000082)=0.000000000000000E+00 beta (00000083)=0.128397173211924E+02 gamma(00000083)=0.128397173211924E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 83 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000083)=0.000000000000000E+00 beta (00000084)=0.133719728525704E+02 gamma(00000084)=0.133719728525704E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 84 z1= 1 -.694957028764265E-07 0.000000000000000E+00 z1= 2 -.241578318462502E-01 0.000000000000000E+00 z1= 3 0.105360380121090E-06 0.000000000000000E+00 alpha(00000084)=0.000000000000000E+00 beta (00000085)=0.128118030739491E+02 gamma(00000085)=0.128118030739491E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 85 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000085)=0.000000000000000E+00 beta (00000086)=0.133220377493676E+02 gamma(00000086)=0.133220377493676E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 86 z1= 1 0.724560779942138E-07 0.000000000000000E+00 z1= 2 0.231343092860840E-01 0.000000000000000E+00 z1= 3 -.115897670936480E-06 0.000000000000000E+00 alpha(00000086)=0.000000000000000E+00 beta (00000087)=0.127545624746920E+02 gamma(00000087)=0.127545624746920E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 87 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000087)=0.000000000000000E+00 beta (00000088)=0.133437910725314E+02 gamma(00000088)=0.133437910725314E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 88 z1= 1 -.771025610571061E-07 0.000000000000000E+00 z1= 2 -.220399438130188E-01 0.000000000000000E+00 z1= 3 0.125427117460584E-06 0.000000000000000E+00 alpha(00000088)=0.000000000000000E+00 beta (00000089)=0.128929326076920E+02 gamma(00000089)=0.128929326076920E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 89 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000089)=0.000000000000000E+00 beta (00000090)=0.133926942869207E+02 gamma(00000090)=0.133926942869207E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 90 z1= 1 0.845768851958847E-07 0.000000000000000E+00 z1= 2 0.211691644162490E-01 0.000000000000000E+00 z1= 3 -.133304056896421E-06 0.000000000000000E+00 alpha(00000090)=0.000000000000000E+00 beta (00000091)=0.126659766501558E+02 gamma(00000091)=0.126659766501558E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 91 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000091)=0.000000000000000E+00 beta (00000092)=0.133460219735640E+02 gamma(00000092)=0.133460219735640E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 92 z1= 1 -.912905817641863E-07 0.000000000000000E+00 z1= 2 -.200728548787433E-01 0.000000000000000E+00 z1= 3 0.140863837824157E-06 0.000000000000000E+00 alpha(00000092)=0.000000000000000E+00 beta (00000093)=0.127909474578124E+02 gamma(00000093)=0.127909474578124E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 93 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000093)=0.000000000000000E+00 beta (00000094)=0.133463368000418E+02 gamma(00000094)=0.133463368000418E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 94 z1= 1 0.883105771669335E-07 0.000000000000000E+00 z1= 2 0.192658865086337E-01 0.000000000000000E+00 z1= 3 -.145286962276742E-06 0.000000000000000E+00 alpha(00000094)=0.000000000000000E+00 beta (00000095)=0.127865900281780E+02 gamma(00000095)=0.127865900281780E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 95 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000095)=0.000000000000000E+00 beta (00000096)=0.133903069631951E+02 gamma(00000096)=0.133903069631951E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 96 z1= 1 -.789639176108047E-07 0.000000000000000E+00 z1= 2 -.184043245992100E-01 0.000000000000000E+00 z1= 3 0.141315536540660E-06 0.000000000000000E+00 alpha(00000096)=0.000000000000000E+00 beta (00000097)=0.127921102215009E+02 gamma(00000097)=0.127921102215009E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 97 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000097)=0.000000000000000E+00 beta (00000098)=0.134511217398412E+02 gamma(00000098)=0.134511217398412E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 98 z1= 1 0.703757811410313E-07 0.000000000000000E+00 z1= 2 0.174969488185511E-01 0.000000000000000E+00 z1= 3 -.131499259532265E-06 0.000000000000000E+00 alpha(00000098)=0.000000000000000E+00 beta (00000099)=0.130150098615429E+02 gamma(00000099)=0.130150098615429E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 99 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000099)=0.000000000000000E+00 beta (00000100)=0.136151550985002E+02 gamma(00000100)=0.136151550985002E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 100 z1= 1 -.601835792386936E-07 0.000000000000000E+00 z1= 2 -.167427942011645E-01 0.000000000000000E+00 z1= 3 0.123455548423405E-06 0.000000000000000E+00 alpha(00000100)=0.000000000000000E+00 beta (00000101)=0.127970455982188E+02 gamma(00000101)=0.127970455982188E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 101 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000101)=0.000000000000000E+00 beta (00000102)=0.132883966049866E+02 gamma(00000102)=0.132883966049866E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 102 z1= 1 0.542874351288497E-07 0.000000000000000E+00 z1= 2 0.161683904978302E-01 0.000000000000000E+00 z1= 3 -.119235278410148E-06 0.000000000000000E+00 alpha(00000102)=0.000000000000000E+00 beta (00000103)=0.128815598097393E+02 gamma(00000103)=0.128815598097393E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 103 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000103)=0.000000000000000E+00 beta (00000104)=0.134149792948886E+02 gamma(00000104)=0.134149792948886E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 104 z1= 1 -.552483444473274E-07 0.000000000000000E+00 z1= 2 -.156162531677051E-01 0.000000000000000E+00 z1= 3 0.117322865464371E-06 0.000000000000000E+00 alpha(00000104)=0.000000000000000E+00 beta (00000105)=0.128779018116752E+02 gamma(00000105)=0.128779018116752E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 105 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000105)=0.000000000000000E+00 beta (00000106)=0.132661748574989E+02 gamma(00000106)=0.132661748574989E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 106 z1= 1 0.608206462841864E-07 0.000000000000000E+00 z1= 2 0.152608898361101E-01 0.000000000000000E+00 z1= 3 -.119770038453659E-06 0.000000000000000E+00 alpha(00000106)=0.000000000000000E+00 beta (00000107)=0.126949041272688E+02 gamma(00000107)=0.126949041272688E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 107 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000107)=0.000000000000000E+00 beta (00000108)=0.133397981466551E+02 gamma(00000108)=0.133397981466551E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 108 z1= 1 -.689284331096759E-07 0.000000000000000E+00 z1= 2 -.145791638251358E-01 0.000000000000000E+00 z1= 3 0.117702350536345E-06 0.000000000000000E+00 alpha(00000108)=0.000000000000000E+00 beta (00000109)=0.128482331792538E+02 gamma(00000109)=0.128482331792538E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 109 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000109)=0.000000000000000E+00 beta (00000110)=0.133221250667475E+02 gamma(00000110)=0.133221250667475E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 110 z1= 1 0.748071789596037E-07 0.000000000000000E+00 z1= 2 0.141136438116091E-01 0.000000000000000E+00 z1= 3 -.120063876094510E-06 0.000000000000000E+00 alpha(00000110)=0.000000000000000E+00 beta (00000111)=0.126966174189624E+02 gamma(00000111)=0.126966174189624E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 111 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000111)=0.000000000000000E+00 beta (00000112)=0.135208588144847E+02 gamma(00000112)=0.135208588144847E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 112 z1= 1 -.751633251173077E-07 0.000000000000000E+00 z1= 2 -.133122856731879E-01 0.000000000000000E+00 z1= 3 0.115675783572461E-06 0.000000000000000E+00 alpha(00000112)=0.000000000000000E+00 beta (00000113)=0.129787356223218E+02 gamma(00000113)=0.129787356223218E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 113 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000113)=0.000000000000000E+00 beta (00000114)=0.134375145551971E+02 gamma(00000114)=0.134375145551971E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 114 z1= 1 0.763989322235224E-07 0.000000000000000E+00 z1= 2 0.128906149989938E-01 0.000000000000000E+00 z1= 3 -.117143263791617E-06 0.000000000000000E+00 alpha(00000114)=0.000000000000000E+00 beta (00000115)=0.127032861226137E+02 gamma(00000115)=0.127032861226137E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 115 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000115)=0.000000000000000E+00 beta (00000116)=0.135071541244879E+02 gamma(00000116)=0.135071541244879E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 116 z1= 1 -.783329282526019E-07 0.000000000000000E+00 z1= 2 -.122054799849471E-01 0.000000000000000E+00 z1= 3 0.120052131383241E-06 0.000000000000000E+00 alpha(00000116)=0.000000000000000E+00 beta (00000117)=0.127084751990547E+02 gamma(00000117)=0.127084751990547E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 117 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000117)=0.000000000000000E+00 beta (00000118)=0.132508100091250E+02 gamma(00000118)=0.132508100091250E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 118 z1= 1 0.791569009495324E-07 0.000000000000000E+00 z1= 2 0.118201706908157E-01 0.000000000000000E+00 z1= 3 -.123088917570340E-06 0.000000000000000E+00 alpha(00000118)=0.000000000000000E+00 beta (00000119)=0.127948196527493E+02 gamma(00000119)=0.127948196527493E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 119 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000119)=0.000000000000000E+00 beta (00000120)=0.133201070386852E+02 gamma(00000120)=0.133201070386852E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 120 z1= 1 -.777387736921979E-07 0.000000000000000E+00 z1= 2 -.114520976097031E-01 0.000000000000000E+00 z1= 3 0.123611527069636E-06 0.000000000000000E+00 alpha(00000120)=0.000000000000000E+00 beta (00000121)=0.125251292402203E+02 gamma(00000121)=0.125251292402203E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 121 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000121)=0.000000000000000E+00 beta (00000122)=0.131932748989623E+02 gamma(00000122)=0.131932748989623E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 122 z1= 1 0.743380635390492E-07 0.000000000000000E+00 z1= 2 0.109776697383162E-01 0.000000000000000E+00 z1= 3 -.120061530976487E-06 0.000000000000000E+00 alpha(00000122)=0.000000000000000E+00 beta (00000123)=0.127052692242900E+02 gamma(00000123)=0.127052692242900E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 123 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000123)=0.000000000000000E+00 beta (00000124)=0.133822009602943E+02 gamma(00000124)=0.133822009602943E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 124 z1= 1 -.683234630085346E-07 0.000000000000000E+00 z1= 2 -.104974549906062E-01 0.000000000000000E+00 z1= 3 0.118457410006804E-06 0.000000000000000E+00 alpha(00000124)=0.000000000000000E+00 beta (00000125)=0.126842713105048E+02 gamma(00000125)=0.126842713105048E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 125 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000125)=0.000000000000000E+00 beta (00000126)=0.133806501119065E+02 gamma(00000126)=0.133806501119065E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 126 z1= 1 0.649751133951181E-07 0.000000000000000E+00 z1= 2 0.100322855848877E-01 0.000000000000000E+00 z1= 3 -.120510818948222E-06 0.000000000000000E+00 alpha(00000126)=0.000000000000000E+00 beta (00000127)=0.128062276862696E+02 gamma(00000127)=0.128062276862696E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 127 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000127)=0.000000000000000E+00 beta (00000128)=0.132909502695981E+02 gamma(00000128)=0.132909502695981E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 128 z1= 1 -.608790960759595E-07 0.000000000000000E+00 z1= 2 -.972833753487027E-02 0.000000000000000E+00 z1= 3 0.124399232865138E-06 0.000000000000000E+00 alpha(00000128)=0.000000000000000E+00 beta (00000129)=0.127748177656693E+02 gamma(00000129)=0.127748177656693E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 129 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000129)=0.000000000000000E+00 beta (00000130)=0.132952911433255E+02 gamma(00000130)=0.132952911433255E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 130 z1= 1 0.629313449559098E-07 0.000000000000000E+00 z1= 2 0.940654619581618E-02 0.000000000000000E+00 z1= 3 -.127803635939961E-06 0.000000000000000E+00 alpha(00000130)=0.000000000000000E+00 beta (00000131)=0.127447082586735E+02 gamma(00000131)=0.127447082586735E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 131 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000131)=0.000000000000000E+00 beta (00000132)=0.131435715152886E+02 gamma(00000132)=0.131435715152886E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 132 z1= 1 -.657035968002276E-07 0.000000000000000E+00 z1= 2 -.917007735398501E-02 0.000000000000000E+00 z1= 3 0.130091785852235E-06 0.000000000000000E+00 alpha(00000132)=0.000000000000000E+00 beta (00000133)=0.127574451215368E+02 gamma(00000133)=0.127574451215368E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 133 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000133)=0.000000000000000E+00 beta (00000134)=0.134673016607018E+02 gamma(00000134)=0.134673016607018E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 134 z1= 1 0.645158477327254E-07 0.000000000000000E+00 z1= 2 0.868566790002963E-02 0.000000000000000E+00 z1= 3 -.127377480116603E-06 0.000000000000000E+00 alpha(00000134)=0.000000000000000E+00 beta (00000135)=0.127762513316984E+02 gamma(00000135)=0.127762513316984E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 135 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000135)=0.000000000000000E+00 beta (00000136)=0.134261514098002E+02 gamma(00000136)=0.134261514098002E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 136 z1= 1 -.637229056552752E-07 0.000000000000000E+00 z1= 2 -.829563145031812E-02 0.000000000000000E+00 z1= 3 0.121328634592149E-06 0.000000000000000E+00 alpha(00000136)=0.000000000000000E+00 beta (00000137)=0.129114147818268E+02 gamma(00000137)=0.129114147818268E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 137 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000137)=0.000000000000000E+00 beta (00000138)=0.133839000978915E+02 gamma(00000138)=0.133839000978915E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 138 z1= 1 0.620452707072137E-07 0.000000000000000E+00 z1= 2 0.808332964401975E-02 0.000000000000000E+00 z1= 3 -.112045163539820E-06 0.000000000000000E+00 alpha(00000138)=0.000000000000000E+00 beta (00000139)=0.129443552120541E+02 gamma(00000139)=0.129443552120541E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 139 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000139)=0.000000000000000E+00 beta (00000140)=0.135474788797269E+02 gamma(00000140)=0.135474788797269E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 140 z1= 1 -.573662644739667E-07 0.000000000000000E+00 z1= 2 -.781485825232854E-02 0.000000000000000E+00 z1= 3 0.101264252492085E-06 0.000000000000000E+00 alpha(00000140)=0.000000000000000E+00 beta (00000141)=0.127277861526766E+02 gamma(00000141)=0.127277861526766E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 141 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000141)=0.000000000000000E+00 beta (00000142)=0.134911119174129E+02 gamma(00000142)=0.134911119174129E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 142 z1= 1 0.553146088026583E-07 0.000000000000000E+00 z1= 2 0.746544375585657E-02 0.000000000000000E+00 z1= 3 -.961824287497802E-07 0.000000000000000E+00 alpha(00000142)=0.000000000000000E+00 beta (00000143)=0.127389217192071E+02 gamma(00000143)=0.127389217192071E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 143 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000143)=0.000000000000000E+00 beta (00000144)=0.134411303322897E+02 gamma(00000144)=0.134411303322897E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 144 z1= 1 -.562280205870184E-07 0.000000000000000E+00 z1= 2 -.714304984625384E-02 0.000000000000000E+00 z1= 3 0.936694945778867E-07 0.000000000000000E+00 alpha(00000144)=0.000000000000000E+00 beta (00000145)=0.129263296894308E+02 gamma(00000145)=0.129263296894308E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 145 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000145)=0.000000000000000E+00 beta (00000146)=0.133959107826440E+02 gamma(00000146)=0.133959107826440E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 146 z1= 1 0.588894717432672E-07 0.000000000000000E+00 z1= 2 0.694247635970714E-02 0.000000000000000E+00 z1= 3 -.945245305339869E-07 0.000000000000000E+00 alpha(00000146)=0.000000000000000E+00 beta (00000147)=0.128292389527626E+02 gamma(00000147)=0.128292389527626E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 147 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000147)=0.000000000000000E+00 beta (00000148)=0.136379004078857E+02 gamma(00000148)=0.136379004078857E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 148 z1= 1 -.586286607182551E-07 0.000000000000000E+00 z1= 2 -.656290162092872E-02 0.000000000000000E+00 z1= 3 0.952703130699742E-07 0.000000000000000E+00 alpha(00000148)=0.000000000000000E+00 beta (00000149)=0.127202834856621E+02 gamma(00000149)=0.127202834856621E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 149 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000149)=0.000000000000000E+00 beta (00000150)=0.135409237548183E+02 gamma(00000150)=0.135409237548183E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 150 z1= 1 0.578521358693840E-07 0.000000000000000E+00 z1= 2 0.617487987683733E-02 0.000000000000000E+00 z1= 3 -.959751901041567E-07 0.000000000000000E+00 alpha(00000150)=0.000000000000000E+00 beta (00000151)=0.126679667557171E+02 gamma(00000151)=0.126679667557171E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 151 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000151)=0.000000000000000E+00 beta (00000152)=0.134959029406305E+02 gamma(00000152)=0.134959029406305E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 152 z1= 1 -.578809158928873E-07 0.000000000000000E+00 z1= 2 -.579244986575931E-02 0.000000000000000E+00 z1= 3 0.951449172790554E-07 0.000000000000000E+00 alpha(00000152)=0.000000000000000E+00 beta (00000153)=0.125474369610128E+02 gamma(00000153)=0.125474369610128E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 153 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000153)=0.000000000000000E+00 beta (00000154)=0.132884249627196E+02 gamma(00000154)=0.132884249627196E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 154 z1= 1 0.568404997416515E-07 0.000000000000000E+00 z1= 2 0.544619695062989E-02 0.000000000000000E+00 z1= 3 -.943322699534840E-07 0.000000000000000E+00 alpha(00000154)=0.000000000000000E+00 beta (00000155)=0.128414504176646E+02 gamma(00000155)=0.128414504176646E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 155 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000155)=0.000000000000000E+00 beta (00000156)=0.133881968013332E+02 gamma(00000156)=0.133881968013332E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 156 z1= 1 -.506452085997922E-07 0.000000000000000E+00 z1= 2 -.518392386097372E-02 0.000000000000000E+00 z1= 3 0.895699759151988E-07 0.000000000000000E+00 alpha(00000156)=0.000000000000000E+00 beta (00000157)=0.128085747927272E+02 gamma(00000157)=0.128085747927272E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 157 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000157)=0.000000000000000E+00 beta (00000158)=0.135345772265009E+02 gamma(00000158)=0.135345772265009E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 158 z1= 1 0.453098883525585E-07 0.000000000000000E+00 z1= 2 0.481534163832608E-02 0.000000000000000E+00 z1= 3 -.842602838106938E-07 0.000000000000000E+00 alpha(00000158)=0.000000000000000E+00 beta (00000159)=0.127048642556668E+02 gamma(00000159)=0.127048642556668E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 159 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000159)=0.000000000000000E+00 beta (00000160)=0.132661192967993E+02 gamma(00000160)=0.132661192967993E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 160 z1= 1 -.388130528741065E-07 0.000000000000000E+00 z1= 2 -.451286169372071E-02 0.000000000000000E+00 z1= 3 0.878378417888687E-07 0.000000000000000E+00 alpha(00000160)=0.000000000000000E+00 beta (00000161)=0.125636014213344E+02 gamma(00000161)=0.125636014213344E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 161 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000161)=0.000000000000000E+00 beta (00000162)=0.133040218200723E+02 gamma(00000162)=0.133040218200723E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 162 z1= 1 0.368279718249154E-07 0.000000000000000E+00 z1= 2 0.422477539894748E-02 0.000000000000000E+00 z1= 3 -.911322640069668E-07 0.000000000000000E+00 alpha(00000162)=0.000000000000000E+00 beta (00000163)=0.127496101313913E+02 gamma(00000163)=0.127496101313913E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 163 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000163)=0.000000000000000E+00 beta (00000164)=0.131753994061017E+02 gamma(00000164)=0.131753994061017E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 164 z1= 1 -.379115680667307E-07 0.000000000000000E+00 z1= 2 -.410525108261481E-02 0.000000000000000E+00 z1= 3 0.889512329928222E-07 0.000000000000000E+00 alpha(00000164)=0.000000000000000E+00 beta (00000165)=0.126037224586014E+02 gamma(00000165)=0.126037224586014E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 165 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000165)=0.000000000000000E+00 beta (00000166)=0.134361143003284E+02 gamma(00000166)=0.134361143003284E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 166 z1= 1 0.319298716516293E-07 0.000000000000000E+00 z1= 2 0.389267995853380E-02 0.000000000000000E+00 z1= 3 -.770505529595298E-07 0.000000000000000E+00 alpha(00000166)=0.000000000000000E+00 beta (00000167)=0.127184986401240E+02 gamma(00000167)=0.127184986401240E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 167 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000167)=0.000000000000000E+00 beta (00000168)=0.134467298109553E+02 gamma(00000168)=0.134467298109553E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 168 z1= 1 -.258554666092946E-07 0.000000000000000E+00 z1= 2 -.378944238163441E-02 0.000000000000000E+00 z1= 3 0.662869955867694E-07 0.000000000000000E+00 alpha(00000168)=0.000000000000000E+00 beta (00000169)=0.127725691557316E+02 gamma(00000169)=0.127725691557316E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 169 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000169)=0.000000000000000E+00 beta (00000170)=0.132924813287231E+02 gamma(00000170)=0.132924813287231E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 170 z1= 1 0.267518438191658E-07 0.000000000000000E+00 z1= 2 0.374997240276435E-02 0.000000000000000E+00 z1= 3 -.650912528764509E-07 0.000000000000000E+00 alpha(00000170)=0.000000000000000E+00 beta (00000171)=0.127568409166211E+02 gamma(00000171)=0.127568409166211E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 171 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000171)=0.000000000000000E+00 beta (00000172)=0.133684001267153E+02 gamma(00000172)=0.133684001267153E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 172 z1= 1 -.280597297287657E-07 0.000000000000000E+00 z1= 2 -.370823128455171E-02 0.000000000000000E+00 z1= 3 0.637324445158620E-07 0.000000000000000E+00 alpha(00000172)=0.000000000000000E+00 beta (00000173)=0.127959853835085E+02 gamma(00000173)=0.127959853835085E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 173 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000173)=0.000000000000000E+00 beta (00000174)=0.134744101898222E+02 gamma(00000174)=0.134744101898222E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 174 z1= 1 0.317212212790421E-07 0.000000000000000E+00 z1= 2 0.356663372895667E-02 0.000000000000000E+00 z1= 3 -.597100098903526E-07 0.000000000000000E+00 alpha(00000174)=0.000000000000000E+00 beta (00000175)=0.128361284546649E+02 gamma(00000175)=0.128361284546649E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 175 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000175)=0.000000000000000E+00 beta (00000176)=0.133958468355374E+02 gamma(00000176)=0.133958468355374E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 176 z1= 1 -.351831669943847E-07 0.000000000000000E+00 z1= 2 -.335056501834196E-02 0.000000000000000E+00 z1= 3 0.624922552772307E-07 0.000000000000000E+00 alpha(00000176)=0.000000000000000E+00 beta (00000177)=0.127371039130295E+02 gamma(00000177)=0.127371039130295E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 177 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000177)=0.000000000000000E+00 beta (00000178)=0.133612405200132E+02 gamma(00000178)=0.133612405200132E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 178 z1= 1 0.343071777878651E-07 0.000000000000000E+00 z1= 2 0.311756268855473E-02 0.000000000000000E+00 z1= 3 -.642765930805025E-07 0.000000000000000E+00 alpha(00000178)=0.000000000000000E+00 beta (00000179)=0.126228394251029E+02 gamma(00000179)=0.126228394251029E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 179 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000179)=0.000000000000000E+00 beta (00000180)=0.134190350667987E+02 gamma(00000180)=0.134190350667987E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 180 z1= 1 -.312521071851174E-07 0.000000000000000E+00 z1= 2 -.280068870895209E-02 0.000000000000000E+00 z1= 3 0.634609180535776E-07 0.000000000000000E+00 alpha(00000180)=0.000000000000000E+00 beta (00000181)=0.127642876405305E+02 gamma(00000181)=0.127642876405305E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 181 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000181)=0.000000000000000E+00 beta (00000182)=0.134410612423757E+02 gamma(00000182)=0.134410612423757E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 182 z1= 1 0.264063843733939E-07 0.000000000000000E+00 z1= 2 0.252339960020117E-02 0.000000000000000E+00 z1= 3 -.630121004128103E-07 0.000000000000000E+00 alpha(00000182)=0.000000000000000E+00 beta (00000183)=0.128179288014428E+02 gamma(00000183)=0.128179288014428E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 183 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000183)=0.000000000000000E+00 beta (00000184)=0.135091040296339E+02 gamma(00000184)=0.135091040296339E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 184 z1= 1 -.221152150273185E-07 0.000000000000000E+00 z1= 2 -.228736882932819E-02 0.000000000000000E+00 z1= 3 0.654049157654073E-07 0.000000000000000E+00 alpha(00000184)=0.000000000000000E+00 beta (00000185)=0.129153918859773E+02 gamma(00000185)=0.129153918859773E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 185 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000185)=0.000000000000000E+00 beta (00000186)=0.133112574597142E+02 gamma(00000186)=0.133112574597142E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 186 z1= 1 0.232952788001457E-07 0.000000000000000E+00 z1= 2 0.207940437724624E-02 0.000000000000000E+00 z1= 3 -.696114074411167E-07 0.000000000000000E+00 alpha(00000186)=0.000000000000000E+00 beta (00000187)=0.127265515630363E+02 gamma(00000187)=0.127265515630363E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 187 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000187)=0.000000000000000E+00 beta (00000188)=0.134540128943669E+02 gamma(00000188)=0.134540128943669E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 188 z1= 1 -.198945390881763E-07 0.000000000000000E+00 z1= 2 -.185387141677072E-02 0.000000000000000E+00 z1= 3 0.663537065394629E-07 0.000000000000000E+00 alpha(00000188)=0.000000000000000E+00 beta (00000189)=0.129511696311227E+02 gamma(00000189)=0.129511696311227E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 189 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000189)=0.000000000000000E+00 beta (00000190)=0.137069654563206E+02 gamma(00000190)=0.137069654563206E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 190 z1= 1 0.160659207959837E-07 0.000000000000000E+00 z1= 2 0.163077383684603E-02 0.000000000000000E+00 z1= 3 -.593537077762918E-07 0.000000000000000E+00 alpha(00000190)=0.000000000000000E+00 beta (00000191)=0.128653297088543E+02 gamma(00000191)=0.128653297088543E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 191 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000191)=0.000000000000000E+00 beta (00000192)=0.134375812782957E+02 gamma(00000192)=0.134375812782957E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 192 z1= 1 -.133501464104433E-07 0.000000000000000E+00 z1= 2 -.143511560625965E-02 0.000000000000000E+00 z1= 3 0.507452248223368E-07 0.000000000000000E+00 alpha(00000192)=0.000000000000000E+00 beta (00000193)=0.127839846798756E+02 gamma(00000193)=0.127839846798756E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 193 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000193)=0.000000000000000E+00 beta (00000194)=0.131984572110381E+02 gamma(00000194)=0.131984572110381E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 194 z1= 1 0.139035910818285E-07 0.000000000000000E+00 z1= 2 0.131191112260974E-02 0.000000000000000E+00 z1= 3 -.425781040470658E-07 0.000000000000000E+00 alpha(00000194)=0.000000000000000E+00 beta (00000195)=0.126837497424209E+02 gamma(00000195)=0.126837497424209E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 195 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000195)=0.000000000000000E+00 beta (00000196)=0.133145749293406E+02 gamma(00000196)=0.133145749293406E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 196 z1= 1 -.106078325570139E-07 0.000000000000000E+00 z1= 2 -.121256490331898E-02 0.000000000000000E+00 z1= 3 0.444321824544171E-07 0.000000000000000E+00 alpha(00000196)=0.000000000000000E+00 beta (00000197)=0.126075492641733E+02 gamma(00000197)=0.126075492641733E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 197 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000197)=0.000000000000000E+00 beta (00000198)=0.136346682669979E+02 gamma(00000198)=0.136346682669979E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 198 z1= 1 0.572705686368614E-08 0.000000000000000E+00 z1= 2 0.114046913969122E-02 0.000000000000000E+00 z1= 3 -.472295224170039E-07 0.000000000000000E+00 alpha(00000198)=0.000000000000000E+00 beta (00000199)=0.126706441860530E+02 gamma(00000199)=0.126706441860530E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 199 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000199)=0.000000000000000E+00 beta (00000200)=0.134979844183191E+02 gamma(00000200)=0.134979844183191E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 200 z1= 1 -.221908561751777E-08 0.000000000000000E+00 z1= 2 -.113630581690429E-02 0.000000000000000E+00 z1= 3 0.477477702755854E-07 0.000000000000000E+00 alpha(00000200)=0.000000000000000E+00 beta (00000201)=0.126144790947480E+02 gamma(00000201)=0.126144790947480E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 201 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000201)=0.000000000000000E+00 beta (00000202)=0.133827091052186E+02 gamma(00000202)=0.133827091052186E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 202 z1= 1 0.644560610484415E-08 0.000000000000000E+00 z1= 2 0.113724816781954E-02 0.000000000000000E+00 z1= 3 -.451923213310649E-07 0.000000000000000E+00 alpha(00000202)=0.000000000000000E+00 beta (00000203)=0.127737670930154E+02 gamma(00000203)=0.127737670930154E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 203 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000203)=0.000000000000000E+00 beta (00000204)=0.135577204971587E+02 gamma(00000204)=0.135577204971587E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 204 z1= 1 -.165317055626432E-07 0.000000000000000E+00 z1= 2 -.111812997686226E-02 0.000000000000000E+00 z1= 3 0.413989668073401E-07 0.000000000000000E+00 alpha(00000204)=0.000000000000000E+00 beta (00000205)=0.128451016987637E+02 gamma(00000205)=0.128451016987637E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 205 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000205)=0.000000000000000E+00 beta (00000206)=0.134794013237468E+02 gamma(00000206)=0.134794013237468E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 206 z1= 1 0.265523455614085E-07 0.000000000000000E+00 z1= 2 0.117275967324810E-02 0.000000000000000E+00 z1= 3 -.383529360248628E-07 0.000000000000000E+00 alpha(00000206)=0.000000000000000E+00 beta (00000207)=0.127619766967730E+02 gamma(00000207)=0.127619766967730E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 207 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000207)=0.000000000000000E+00 beta (00000208)=0.133843609809238E+02 gamma(00000208)=0.133843609809238E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 208 z1= 1 -.305789075406501E-07 0.000000000000000E+00 z1= 2 -.124900444117075E-02 0.000000000000000E+00 z1= 3 0.350112625926741E-07 0.000000000000000E+00 alpha(00000208)=0.000000000000000E+00 beta (00000209)=0.126285787500456E+02 gamma(00000209)=0.126285787500456E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 209 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000209)=0.000000000000000E+00 beta (00000210)=0.135245909440703E+02 gamma(00000210)=0.135245909440703E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 210 z1= 1 0.256226192303297E-07 0.000000000000000E+00 z1= 2 0.133098731678504E-02 0.000000000000000E+00 z1= 3 -.368268315733395E-07 0.000000000000000E+00 alpha(00000210)=0.000000000000000E+00 beta (00000211)=0.126502754134997E+02 gamma(00000211)=0.126502754134997E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 211 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000211)=0.000000000000000E+00 beta (00000212)=0.135865805538855E+02 gamma(00000212)=0.135865805538855E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 212 z1= 1 -.205833134338945E-07 0.000000000000000E+00 z1= 2 -.133864625623288E-02 0.000000000000000E+00 z1= 3 0.424376914746411E-07 0.000000000000000E+00 alpha(00000212)=0.000000000000000E+00 beta (00000213)=0.126861041706371E+02 gamma(00000213)=0.126861041706371E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 213 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000213)=0.000000000000000E+00 beta (00000214)=0.134728737278565E+02 gamma(00000214)=0.134728737278565E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 214 z1= 1 0.166015081889959E-07 0.000000000000000E+00 z1= 2 0.123944828518386E-02 0.000000000000000E+00 z1= 3 -.461358021170213E-07 0.000000000000000E+00 alpha(00000214)=0.000000000000000E+00 beta (00000215)=0.125569300171512E+02 gamma(00000215)=0.125569300171512E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 215 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000215)=0.000000000000000E+00 beta (00000216)=0.132491064588091E+02 gamma(00000216)=0.132491064588091E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 216 z1= 1 -.148885400683488E-07 0.000000000000000E+00 z1= 2 -.111655553363734E-02 0.000000000000000E+00 z1= 3 0.425016777184754E-07 0.000000000000000E+00 alpha(00000216)=0.000000000000000E+00 beta (00000217)=0.124623000237172E+02 gamma(00000217)=0.124623000237172E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 217 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000217)=0.000000000000000E+00 beta (00000218)=0.136511873728694E+02 gamma(00000218)=0.136511873728694E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 218 z1= 1 0.136630325777223E-07 0.000000000000000E+00 z1= 2 0.924449202904932E-03 0.000000000000000E+00 z1= 3 -.348631468184983E-07 0.000000000000000E+00 alpha(00000218)=0.000000000000000E+00 beta (00000219)=0.127279557299646E+02 gamma(00000219)=0.127279557299646E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 219 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000219)=0.000000000000000E+00 beta (00000220)=0.134284314610689E+02 gamma(00000220)=0.134284314610689E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 220 z1= 1 -.124096574839055E-07 0.000000000000000E+00 z1= 2 -.774276403293177E-03 0.000000000000000E+00 z1= 3 0.326370477758209E-07 0.000000000000000E+00 alpha(00000220)=0.000000000000000E+00 beta (00000221)=0.127708036485076E+02 gamma(00000221)=0.127708036485076E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 221 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000221)=0.000000000000000E+00 beta (00000222)=0.132931670005845E+02 gamma(00000222)=0.132931670005845E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 222 z1= 1 0.161714917576786E-07 0.000000000000000E+00 z1= 2 0.618112224757578E-03 0.000000000000000E+00 z1= 3 -.323896510085776E-07 0.000000000000000E+00 alpha(00000222)=0.000000000000000E+00 beta (00000223)=0.128285614545828E+02 gamma(00000223)=0.128285614545828E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 223 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000223)=0.000000000000000E+00 beta (00000224)=0.132059505417402E+02 gamma(00000224)=0.132059505417402E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 224 z1= 1 -.211846812002425E-07 0.000000000000000E+00 z1= 2 -.427791356267240E-03 0.000000000000000E+00 z1= 3 0.339335094098870E-07 0.000000000000000E+00 alpha(00000224)=0.000000000000000E+00 beta (00000225)=0.129768300197679E+02 gamma(00000225)=0.129768300197679E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 225 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000225)=0.000000000000000E+00 beta (00000226)=0.133547452658849E+02 gamma(00000226)=0.133547452658849E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 226 z1= 1 0.224941519655700E-07 0.000000000000000E+00 z1= 2 0.233655585324679E-03 0.000000000000000E+00 z1= 3 -.342586701917590E-07 0.000000000000000E+00 alpha(00000226)=0.000000000000000E+00 beta (00000227)=0.128221375771886E+02 gamma(00000227)=0.128221375771886E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 227 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000227)=0.000000000000000E+00 beta (00000228)=0.135114458412687E+02 gamma(00000228)=0.135114458412687E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 228 z1= 1 -.225478663700221E-07 0.000000000000000E+00 z1= 2 -.742523826872869E-04 0.000000000000000E+00 z1= 3 0.264139233653940E-07 0.000000000000000E+00 alpha(00000228)=0.000000000000000E+00 beta (00000229)=0.127023365153309E+02 gamma(00000229)=0.127023365153309E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 229 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000229)=0.000000000000000E+00 beta (00000230)=0.134493720743344E+02 gamma(00000230)=0.134493720743344E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 230 z1= 1 0.176834737538809E-07 0.000000000000000E+00 z1= 2 -.479611653936758E-04 0.000000000000000E+00 z1= 3 -.160262181945613E-07 0.000000000000000E+00 alpha(00000230)=0.000000000000000E+00 beta (00000231)=0.129121589009416E+02 gamma(00000231)=0.129121589009416E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 231 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000231)=0.000000000000000E+00 beta (00000232)=0.137270839819411E+02 gamma(00000232)=0.137270839819411E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 232 z1= 1 -.156745971514882E-07 0.000000000000000E+00 z1= 2 0.115648091387189E-03 0.000000000000000E+00 z1= 3 0.935674046570597E-08 0.000000000000000E+00 alpha(00000232)=0.000000000000000E+00 beta (00000233)=0.127783700622876E+02 gamma(00000233)=0.127783700622876E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 233 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000233)=0.000000000000000E+00 beta (00000234)=0.133505825342286E+02 gamma(00000234)=0.133505825342286E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 234 z1= 1 0.108093583801698E-07 0.000000000000000E+00 z1= 2 -.182074709641074E-03 0.000000000000000E+00 z1= 3 -.143914294193444E-07 0.000000000000000E+00 alpha(00000234)=0.000000000000000E+00 beta (00000235)=0.125912998163892E+02 gamma(00000235)=0.125912998163892E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 235 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000235)=0.000000000000000E+00 beta (00000236)=0.133931014716808E+02 gamma(00000236)=0.133931014716808E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 236 z1= 1 -.766804343849473E-08 0.000000000000000E+00 z1= 2 0.215514923536294E-03 0.000000000000000E+00 z1= 3 0.260894527662556E-07 0.000000000000000E+00 alpha(00000236)=0.000000000000000E+00 beta (00000237)=0.128916040294615E+02 gamma(00000237)=0.128916040294615E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 237 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000237)=0.000000000000000E+00 beta (00000238)=0.135199836411669E+02 gamma(00000238)=0.135199836411669E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 238 z1= 1 -.228953601997400E-08 0.000000000000000E+00 z1= 2 -.249011304022076E-03 0.000000000000000E+00 z1= 3 -.328135339728154E-07 0.000000000000000E+00 alpha(00000238)=0.000000000000000E+00 beta (00000239)=0.127637986735729E+02 gamma(00000239)=0.127637986735729E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 239 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000239)=0.000000000000000E+00 beta (00000240)=0.133599247492301E+02 gamma(00000240)=0.133599247492301E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 240 z1= 1 0.874736112580279E-08 0.000000000000000E+00 z1= 2 0.256603245740185E-03 0.000000000000000E+00 z1= 3 0.347741641273285E-07 0.000000000000000E+00 alpha(00000240)=0.000000000000000E+00 beta (00000241)=0.127491479930012E+02 gamma(00000241)=0.127491479930012E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 241 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000241)=0.000000000000000E+00 beta (00000242)=0.134030849947503E+02 gamma(00000242)=0.134030849947503E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 242 z1= 1 -.759425754942068E-08 0.000000000000000E+00 z1= 2 -.218618566388439E-03 0.000000000000000E+00 z1= 3 -.313327877551439E-07 0.000000000000000E+00 alpha(00000242)=0.000000000000000E+00 beta (00000243)=0.128891579146720E+02 gamma(00000243)=0.128891579146720E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 243 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000243)=0.000000000000000E+00 beta (00000244)=0.135143966505470E+02 gamma(00000244)=0.135143966505470E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 244 z1= 1 0.455182687982697E-08 0.000000000000000E+00 z1= 2 0.177575654857744E-03 0.000000000000000E+00 z1= 3 0.276819270341464E-07 0.000000000000000E+00 alpha(00000244)=0.000000000000000E+00 beta (00000245)=0.125468371095522E+02 gamma(00000245)=0.125468371095522E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 245 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000245)=0.000000000000000E+00 beta (00000246)=0.130512642263343E+02 gamma(00000246)=0.130512642263343E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 246 z1= 1 0.395287959569640E-08 0.000000000000000E+00 z1= 2 -.695163509533206E-04 0.000000000000000E+00 z1= 3 -.271849999822302E-07 0.000000000000000E+00 alpha(00000246)=0.000000000000000E+00 beta (00000247)=0.125670620392076E+02 gamma(00000247)=0.125670620392076E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 247 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000247)=0.000000000000000E+00 beta (00000248)=0.133323989999513E+02 gamma(00000248)=0.133323989999513E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 248 z1= 1 -.107344720907260E-07 0.000000000000000E+00 z1= 2 -.259081202673918E-04 0.000000000000000E+00 z1= 3 0.271697752981951E-07 0.000000000000000E+00 alpha(00000248)=0.000000000000000E+00 beta (00000249)=0.127879982464477E+02 gamma(00000249)=0.127879982464477E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 249 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000249)=0.000000000000000E+00 beta (00000250)=0.134569267485904E+02 gamma(00000250)=0.134569267485904E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 250 z1= 1 0.153550049663068E-07 0.000000000000000E+00 z1= 2 0.128047768740153E-03 0.000000000000000E+00 z1= 3 -.275790780935735E-07 0.000000000000000E+00 alpha(00000250)=0.000000000000000E+00 beta (00000251)=0.125505323317055E+02 gamma(00000251)=0.125505323317055E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 251 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000251)=0.000000000000000E+00 beta (00000252)=0.132839999138780E+02 gamma(00000252)=0.132839999138780E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 252 z1= 1 -.136999709476199E-07 0.000000000000000E+00 z1= 2 -.178463307730263E-03 0.000000000000000E+00 z1= 3 0.372711505206968E-07 0.000000000000000E+00 alpha(00000252)=0.000000000000000E+00 beta (00000253)=0.129335082503105E+02 gamma(00000253)=0.129335082503105E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 253 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000253)=0.000000000000000E+00 beta (00000254)=0.135153301998696E+02 gamma(00000254)=0.135153301998696E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 254 z1= 1 0.129496795149044E-07 0.000000000000000E+00 z1= 2 0.150105679376961E-03 0.000000000000000E+00 z1= 3 -.475638605009691E-07 0.000000000000000E+00 alpha(00000254)=0.000000000000000E+00 beta (00000255)=0.128017636286859E+02 gamma(00000255)=0.128017636286859E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 255 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000255)=0.000000000000000E+00 beta (00000256)=0.136717467816542E+02 gamma(00000256)=0.136717467816542E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 256 z1= 1 -.155274226445318E-07 0.000000000000000E+00 z1= 2 -.136171436259230E-03 0.000000000000000E+00 z1= 3 0.565880178198886E-07 0.000000000000000E+00 alpha(00000256)=0.000000000000000E+00 beta (00000257)=0.128304012446781E+02 gamma(00000257)=0.128304012446781E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 257 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000257)=0.000000000000000E+00 beta (00000258)=0.134220693975090E+02 gamma(00000258)=0.134220693975090E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 258 z1= 1 0.199612806431673E-07 0.000000000000000E+00 z1= 2 0.137405378534134E-03 0.000000000000000E+00 z1= 3 -.609311223082401E-07 0.000000000000000E+00 alpha(00000258)=0.000000000000000E+00 beta (00000259)=0.130323945947064E+02 gamma(00000259)=0.130323945947064E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 259 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000259)=0.000000000000000E+00 beta (00000260)=0.135344420838780E+02 gamma(00000260)=0.135344420838780E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 260 z1= 1 -.169420171875975E-07 0.000000000000000E+00 z1= 2 -.919413515476915E-04 0.000000000000000E+00 z1= 3 0.545247807123578E-07 0.000000000000000E+00 alpha(00000260)=0.000000000000000E+00 beta (00000261)=0.127717813030150E+02 gamma(00000261)=0.127717813030150E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 261 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000261)=0.000000000000000E+00 beta (00000262)=0.133224105951249E+02 gamma(00000262)=0.133224105951249E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 262 z1= 1 0.875971634031053E-08 0.000000000000000E+00 z1= 2 0.470286552968382E-04 0.000000000000000E+00 z1= 3 -.436486977112424E-07 0.000000000000000E+00 alpha(00000262)=0.000000000000000E+00 beta (00000263)=0.126369563225262E+02 gamma(00000263)=0.126369563225262E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 263 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000263)=0.000000000000000E+00 beta (00000264)=0.132589092506441E+02 gamma(00000264)=0.132589092506441E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 264 z1= 1 0.205103301183229E-08 0.000000000000000E+00 z1= 2 -.374653242688969E-05 0.000000000000000E+00 z1= 3 0.363480027838954E-07 0.000000000000000E+00 alpha(00000264)=0.000000000000000E+00 beta (00000265)=0.127325987278193E+02 gamma(00000265)=0.127325987278193E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 265 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000265)=0.000000000000000E+00 beta (00000266)=0.134482038792321E+02 gamma(00000266)=0.134482038792321E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 266 z1= 1 -.329473284765847E-08 0.000000000000000E+00 z1= 2 0.577032497892744E-05 0.000000000000000E+00 z1= 3 -.333799834160747E-07 0.000000000000000E+00 alpha(00000266)=0.000000000000000E+00 beta (00000267)=0.127991454701057E+02 gamma(00000267)=0.127991454701057E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 267 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000267)=0.000000000000000E+00 beta (00000268)=0.133513084454593E+02 gamma(00000268)=0.133513084454593E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 268 z1= 1 -.154903082721924E-08 0.000000000000000E+00 z1= 2 -.561241787106377E-04 0.000000000000000E+00 z1= 3 0.334442291636855E-07 0.000000000000000E+00 alpha(00000268)=0.000000000000000E+00 beta (00000269)=0.126158978980135E+02 gamma(00000269)=0.126158978980135E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 269 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000269)=0.000000000000000E+00 beta (00000270)=0.135205370329398E+02 gamma(00000270)=0.135205370329398E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 270 z1= 1 0.114045207860736E-07 0.000000000000000E+00 z1= 2 0.126586302181076E-03 0.000000000000000E+00 z1= 3 -.373031817799065E-07 0.000000000000000E+00 alpha(00000270)=0.000000000000000E+00 beta (00000271)=0.130326454906193E+02 gamma(00000271)=0.130326454906193E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 271 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000271)=0.000000000000000E+00 beta (00000272)=0.132961215690828E+02 gamma(00000272)=0.132961215690828E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 272 z1= 1 -.190697370377330E-07 0.000000000000000E+00 z1= 2 -.191098162345598E-03 0.000000000000000E+00 z1= 3 0.432213160856017E-07 0.000000000000000E+00 alpha(00000272)=0.000000000000000E+00 beta (00000273)=0.127265906748361E+02 gamma(00000273)=0.127265906748361E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 273 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000273)=0.000000000000000E+00 beta (00000274)=0.134989002592018E+02 gamma(00000274)=0.134989002592018E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 274 z1= 1 0.235903073447091E-07 0.000000000000000E+00 z1= 2 0.169635850328102E-03 0.000000000000000E+00 z1= 3 -.436074183434603E-07 0.000000000000000E+00 alpha(00000274)=0.000000000000000E+00 beta (00000275)=0.128619356211259E+02 gamma(00000275)=0.128619356211259E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 275 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000275)=0.000000000000000E+00 beta (00000276)=0.137442792451240E+02 gamma(00000276)=0.137442792451240E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 276 z1= 1 -.245105408434865E-07 0.000000000000000E+00 z1= 2 -.142019851008471E-03 0.000000000000000E+00 z1= 3 0.419600204816983E-07 0.000000000000000E+00 alpha(00000276)=0.000000000000000E+00 beta (00000277)=0.127469257533890E+02 gamma(00000277)=0.127469257533890E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 277 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000277)=0.000000000000000E+00 beta (00000278)=0.131865646376601E+02 gamma(00000278)=0.131865646376601E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 278 z1= 1 0.213736376618312E-07 0.000000000000000E+00 z1= 2 0.108791373771344E-03 0.000000000000000E+00 z1= 3 -.403407626096102E-07 0.000000000000000E+00 alpha(00000278)=0.000000000000000E+00 beta (00000279)=0.125348581517804E+02 gamma(00000279)=0.125348581517804E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 279 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000279)=0.000000000000000E+00 beta (00000280)=0.133611703846744E+02 gamma(00000280)=0.133611703846744E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 280 z1= 1 -.140030821799142E-07 0.000000000000000E+00 z1= 2 -.752083981256507E-04 0.000000000000000E+00 z1= 3 0.418613195149735E-07 0.000000000000000E+00 alpha(00000280)=0.000000000000000E+00 beta (00000281)=0.128735877822866E+02 gamma(00000281)=0.128735877822866E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 281 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000281)=0.000000000000000E+00 beta (00000282)=0.132965507756219E+02 gamma(00000282)=0.132965507756219E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 282 z1= 1 0.894435220680223E-08 0.000000000000000E+00 z1= 2 0.268324088373321E-04 0.000000000000000E+00 z1= 3 -.416030478035017E-07 0.000000000000000E+00 alpha(00000282)=0.000000000000000E+00 beta (00000283)=0.125943192750430E+02 gamma(00000283)=0.125943192750430E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 283 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000283)=0.000000000000000E+00 beta (00000284)=0.132145338500301E+02 gamma(00000284)=0.132145338500301E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 284 z1= 1 -.708413476230990E-08 0.000000000000000E+00 z1= 2 0.591583391151844E-04 0.000000000000000E+00 z1= 3 0.441785831994859E-07 0.000000000000000E+00 alpha(00000284)=0.000000000000000E+00 beta (00000285)=0.126626679042510E+02 gamma(00000285)=0.126626679042510E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 285 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000285)=0.000000000000000E+00 beta (00000286)=0.134123830124394E+02 gamma(00000286)=0.134123830124394E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 286 z1= 1 0.709442320428327E-08 0.000000000000000E+00 z1= 2 -.191791282127850E-03 0.000000000000000E+00 z1= 3 -.504763654244028E-07 0.000000000000000E+00 alpha(00000286)=0.000000000000000E+00 beta (00000287)=0.126243410765344E+02 gamma(00000287)=0.126243410765344E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 287 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000287)=0.000000000000000E+00 beta (00000288)=0.130877012364476E+02 gamma(00000288)=0.130877012364476E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 288 z1= 1 -.605720819769201E-08 0.000000000000000E+00 z1= 2 0.350541433280497E-03 0.000000000000000E+00 z1= 3 0.526633174398805E-07 0.000000000000000E+00 alpha(00000288)=0.000000000000000E+00 beta (00000289)=0.127644148084807E+02 gamma(00000289)=0.127644148084807E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 289 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000289)=0.000000000000000E+00 beta (00000290)=0.134269535232220E+02 gamma(00000290)=0.134269535232220E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 290 z1= 1 0.341367424085137E-08 0.000000000000000E+00 z1= 2 -.501939167762655E-03 0.000000000000000E+00 z1= 3 -.522370564991648E-07 0.000000000000000E+00 alpha(00000290)=0.000000000000000E+00 beta (00000291)=0.127608151890502E+02 gamma(00000291)=0.127608151890502E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 291 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000291)=0.000000000000000E+00 beta (00000292)=0.131981571999773E+02 gamma(00000292)=0.131981571999773E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 292 z1= 1 -.277156469042500E-08 0.000000000000000E+00 z1= 2 0.625917029499309E-03 0.000000000000000E+00 z1= 3 0.476573332163768E-07 0.000000000000000E+00 alpha(00000292)=0.000000000000000E+00 beta (00000293)=0.126409953137435E+02 gamma(00000293)=0.126409953137435E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 293 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000293)=0.000000000000000E+00 beta (00000294)=0.135270560989588E+02 gamma(00000294)=0.135270560989588E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 294 z1= 1 0.879158397991409E-09 0.000000000000000E+00 z1= 2 -.726200592537212E-03 0.000000000000000E+00 z1= 3 -.444599270099308E-07 0.000000000000000E+00 alpha(00000294)=0.000000000000000E+00 beta (00000295)=0.129785222093122E+02 gamma(00000295)=0.129785222093122E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 295 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000295)=0.000000000000000E+00 beta (00000296)=0.135626806015086E+02 gamma(00000296)=0.135626806015086E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 296 z1= 1 -.302005335019520E-08 0.000000000000000E+00 z1= 2 0.768647849260513E-03 0.000000000000000E+00 z1= 3 0.393961471436438E-07 0.000000000000000E+00 alpha(00000296)=0.000000000000000E+00 beta (00000297)=0.127909964709271E+02 gamma(00000297)=0.127909964709271E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 297 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000297)=0.000000000000000E+00 beta (00000298)=0.133438364431599E+02 gamma(00000298)=0.133438364431599E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 298 z1= 1 0.453108212322001E-08 0.000000000000000E+00 z1= 2 -.707221860389245E-03 0.000000000000000E+00 z1= 3 -.396793531839143E-07 0.000000000000000E+00 alpha(00000298)=0.000000000000000E+00 beta (00000299)=0.130103420962389E+02 gamma(00000299)=0.130103420962389E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 299 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000299)=0.000000000000000E+00 beta (00000300)=0.136894538336295E+02 gamma(00000300)=0.136894538336295E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 300 z1= 1 -.755068371022238E-08 0.000000000000000E+00 z1= 2 0.684049769650913E-03 0.000000000000000E+00 z1= 3 0.416239458086434E-07 0.000000000000000E+00 alpha(00000300)=0.000000000000000E+00 beta (00000301)=0.127328182135386E+02 gamma(00000301)=0.127328182135386E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 301 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000301)=0.000000000000000E+00 beta (00000302)=0.132016648335663E+02 gamma(00000302)=0.132016648335663E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 302 z1= 1 0.672741625211068E-08 0.000000000000000E+00 z1= 2 -.646448190926114E-03 0.000000000000000E+00 z1= 3 -.391963618696667E-07 0.000000000000000E+00 alpha(00000302)=0.000000000000000E+00 beta (00000303)=0.127866551866332E+02 gamma(00000303)=0.127866551866332E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 303 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000303)=0.000000000000000E+00 beta (00000304)=0.135650719314812E+02 gamma(00000304)=0.135650719314812E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 304 z1= 1 -.793113278090701E-08 0.000000000000000E+00 z1= 2 0.550102254269496E-03 0.000000000000000E+00 z1= 3 0.377228361144095E-07 0.000000000000000E+00 alpha(00000304)=0.000000000000000E+00 beta (00000305)=0.128308351870987E+02 gamma(00000305)=0.128308351870987E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 305 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000305)=0.000000000000000E+00 beta (00000306)=0.134497828561443E+02 gamma(00000306)=0.134497828561443E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 306 z1= 1 0.561503591886559E-09 0.000000000000000E+00 z1= 2 -.425174261712073E-03 0.000000000000000E+00 z1= 3 -.376849367248909E-07 0.000000000000000E+00 alpha(00000306)=0.000000000000000E+00 beta (00000307)=0.127985130296724E+02 gamma(00000307)=0.127985130296724E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 307 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000307)=0.000000000000000E+00 beta (00000308)=0.135697975334785E+02 gamma(00000308)=0.135697975334785E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 308 z1= 1 0.632767300601071E-08 0.000000000000000E+00 z1= 2 0.238249238987056E-03 0.000000000000000E+00 z1= 3 0.377080333265620E-07 0.000000000000000E+00 alpha(00000308)=0.000000000000000E+00 beta (00000309)=0.127887267251490E+02 gamma(00000309)=0.127887267251490E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 309 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000309)=0.000000000000000E+00 beta (00000310)=0.133080244740904E+02 gamma(00000310)=0.133080244740904E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 310 z1= 1 -.108212636911083E-07 0.000000000000000E+00 z1= 2 -.690561864971498E-04 0.000000000000000E+00 z1= 3 -.384578097399352E-07 0.000000000000000E+00 alpha(00000310)=0.000000000000000E+00 beta (00000311)=0.127284882307430E+02 gamma(00000311)=0.127284882307430E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 311 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000311)=0.000000000000000E+00 beta (00000312)=0.134432025279542E+02 gamma(00000312)=0.134432025279542E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 312 z1= 1 0.113468221175309E-07 0.000000000000000E+00 z1= 2 -.753804365312199E-04 0.000000000000000E+00 z1= 3 0.359425841104906E-07 0.000000000000000E+00 alpha(00000312)=0.000000000000000E+00 beta (00000313)=0.128577028614826E+02 gamma(00000313)=0.128577028614826E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 313 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000313)=0.000000000000000E+00 beta (00000314)=0.132270522997332E+02 gamma(00000314)=0.132270522997332E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 314 z1= 1 -.385136318063056E-08 0.000000000000000E+00 z1= 2 0.260460357466427E-03 0.000000000000000E+00 z1= 3 -.382484328509533E-07 0.000000000000000E+00 alpha(00000314)=0.000000000000000E+00 beta (00000315)=0.124468856937342E+02 gamma(00000315)=0.124468856937342E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 315 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000315)=0.000000000000000E+00 beta (00000316)=0.134574572413439E+02 gamma(00000316)=0.134574572413439E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 316 z1= 1 -.591776231381562E-08 0.000000000000000E+00 z1= 2 -.405172571211953E-03 0.000000000000000E+00 z1= 3 0.385095448598126E-07 0.000000000000000E+00 alpha(00000316)=0.000000000000000E+00 beta (00000317)=0.125628254695867E+02 gamma(00000317)=0.125628254695867E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 317 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000317)=0.000000000000000E+00 beta (00000318)=0.134454793417199E+02 gamma(00000318)=0.134454793417199E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 318 z1= 1 0.154593163123259E-07 0.000000000000000E+00 z1= 2 0.508381244661661E-03 0.000000000000000E+00 z1= 3 -.407741232133193E-07 0.000000000000000E+00 alpha(00000318)=0.000000000000000E+00 beta (00000319)=0.125694659135272E+02 gamma(00000319)=0.125694659135272E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 319 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000319)=0.000000000000000E+00 beta (00000320)=0.132681008039540E+02 gamma(00000320)=0.132681008039540E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 320 z1= 1 -.179624650761129E-07 0.000000000000000E+00 z1= 2 -.614322206988970E-03 0.000000000000000E+00 z1= 3 0.454764513890609E-07 0.000000000000000E+00 alpha(00000320)=0.000000000000000E+00 beta (00000321)=0.128765185863578E+02 gamma(00000321)=0.128765185863578E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 321 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000321)=0.000000000000000E+00 beta (00000322)=0.135399501961829E+02 gamma(00000322)=0.135399501961829E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 322 z1= 1 0.205927125802863E-07 0.000000000000000E+00 z1= 2 0.611741289024746E-03 0.000000000000000E+00 z1= 3 -.487768228542491E-07 0.000000000000000E+00 alpha(00000322)=0.000000000000000E+00 beta (00000323)=0.127481118341912E+02 gamma(00000323)=0.127481118341912E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 323 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000323)=0.000000000000000E+00 beta (00000324)=0.132689452870964E+02 gamma(00000324)=0.132689452870964E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 324 z1= 1 -.174968691761708E-07 0.000000000000000E+00 z1= 2 -.593151436588364E-03 0.000000000000000E+00 z1= 3 0.548453163505373E-07 0.000000000000000E+00 alpha(00000324)=0.000000000000000E+00 beta (00000325)=0.127936775248707E+02 gamma(00000325)=0.127936775248707E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 325 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000325)=0.000000000000000E+00 beta (00000326)=0.137030975936482E+02 gamma(00000326)=0.137030975936482E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 326 z1= 1 0.193929465186135E-07 0.000000000000000E+00 z1= 2 0.514678732575984E-03 0.000000000000000E+00 z1= 3 -.542733003935838E-07 0.000000000000000E+00 alpha(00000326)=0.000000000000000E+00 beta (00000327)=0.126567254671540E+02 gamma(00000327)=0.126567254671540E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 327 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000327)=0.000000000000000E+00 beta (00000328)=0.132711557462431E+02 gamma(00000328)=0.132711557462431E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 328 z1= 1 -.205907241569714E-07 0.000000000000000E+00 z1= 2 -.371411167402060E-03 0.000000000000000E+00 z1= 3 0.595071091168044E-07 0.000000000000000E+00 alpha(00000328)=0.000000000000000E+00 beta (00000329)=0.128091298593334E+02 gamma(00000329)=0.128091298593334E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 329 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000329)=0.000000000000000E+00 beta (00000330)=0.136226109030689E+02 gamma(00000330)=0.136226109030689E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 330 z1= 1 0.295918456579003E-07 0.000000000000000E+00 z1= 2 0.203138381405075E-03 0.000000000000000E+00 z1= 3 -.634694248878662E-07 0.000000000000000E+00 alpha(00000330)=0.000000000000000E+00 beta (00000331)=0.126673934992900E+02 gamma(00000331)=0.126673934992900E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 331 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000331)=0.000000000000000E+00 beta (00000332)=0.133665352585104E+02 gamma(00000332)=0.133665352585104E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 332 z1= 1 -.324921365941339E-07 0.000000000000000E+00 z1= 2 0.642199922911563E-05 0.000000000000000E+00 z1= 3 0.669096604181811E-07 0.000000000000000E+00 alpha(00000332)=0.000000000000000E+00 beta (00000333)=0.128362319995764E+02 gamma(00000333)=0.128362319995764E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 333 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000333)=0.000000000000000E+00 beta (00000334)=0.134614562675544E+02 gamma(00000334)=0.134614562675544E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 334 z1= 1 0.376858990441993E-07 0.000000000000000E+00 z1= 2 -.150871242358821E-03 0.000000000000000E+00 z1= 3 -.687033896320621E-07 0.000000000000000E+00 alpha(00000334)=0.000000000000000E+00 beta (00000335)=0.124684181316426E+02 gamma(00000335)=0.124684181316426E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 335 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000335)=0.000000000000000E+00 beta (00000336)=0.130933454946381E+02 gamma(00000336)=0.130933454946381E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 336 z1= 1 -.373164905612296E-07 0.000000000000000E+00 z1= 2 0.269466148561545E-03 0.000000000000000E+00 z1= 3 0.762402207923722E-07 0.000000000000000E+00 alpha(00000336)=0.000000000000000E+00 beta (00000337)=0.129072717412318E+02 gamma(00000337)=0.129072717412318E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 337 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000337)=0.000000000000000E+00 beta (00000338)=0.135019995393913E+02 gamma(00000338)=0.135019995393913E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 338 z1= 1 0.375915846836244E-07 0.000000000000000E+00 z1= 2 -.431478384121667E-03 0.000000000000000E+00 z1= 3 -.822591802473495E-07 0.000000000000000E+00 alpha(00000338)=0.000000000000000E+00 beta (00000339)=0.126384311318096E+02 gamma(00000339)=0.126384311318096E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 339 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000339)=0.000000000000000E+00 beta (00000340)=0.132426379077520E+02 gamma(00000340)=0.132426379077520E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 340 z1= 1 -.317520381090328E-07 0.000000000000000E+00 z1= 2 0.596969702014756E-03 0.000000000000000E+00 z1= 3 0.875838442305175E-07 0.000000000000000E+00 alpha(00000340)=0.000000000000000E+00 beta (00000341)=0.126701054224048E+02 gamma(00000341)=0.126701054224048E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 341 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000341)=0.000000000000000E+00 beta (00000342)=0.136755699066399E+02 gamma(00000342)=0.136755699066399E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 342 z1= 1 0.336719137359991E-07 0.000000000000000E+00 z1= 2 -.713362692611801E-03 0.000000000000000E+00 z1= 3 -.826640721403663E-07 0.000000000000000E+00 alpha(00000342)=0.000000000000000E+00 beta (00000343)=0.127946147068576E+02 gamma(00000343)=0.127946147068576E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 343 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000343)=0.000000000000000E+00 beta (00000344)=0.135430062073817E+02 gamma(00000344)=0.135430062073817E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 344 z1= 1 -.373881306183974E-07 0.000000000000000E+00 z1= 2 0.859063033437672E-03 0.000000000000000E+00 z1= 3 0.796680824653772E-07 0.000000000000000E+00 alpha(00000344)=0.000000000000000E+00 beta (00000345)=0.129528404993229E+02 gamma(00000345)=0.129528404993229E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 345 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000345)=0.000000000000000E+00 beta (00000346)=0.134557759861961E+02 gamma(00000346)=0.134557759861961E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 346 z1= 1 0.401354184826133E-07 0.000000000000000E+00 z1= 2 -.104619474349743E-02 0.000000000000000E+00 z1= 3 -.777019101315998E-07 0.000000000000000E+00 alpha(00000346)=0.000000000000000E+00 beta (00000347)=0.125651995235878E+02 gamma(00000347)=0.125651995235878E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 347 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000347)=0.000000000000000E+00 beta (00000348)=0.134781638303032E+02 gamma(00000348)=0.134781638303032E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 348 z1= 1 -.328014440487828E-07 0.000000000000000E+00 z1= 2 0.117046786651392E-02 0.000000000000000E+00 z1= 3 0.805406103073468E-07 0.000000000000000E+00 alpha(00000348)=0.000000000000000E+00 beta (00000349)=0.129740097800405E+02 gamma(00000349)=0.129740097800405E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 349 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000349)=0.000000000000000E+00 beta (00000350)=0.134304559846862E+02 gamma(00000350)=0.134304559846862E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 350 z1= 1 0.354321351885359E-07 0.000000000000000E+00 z1= 2 -.135438232860309E-02 0.000000000000000E+00 z1= 3 -.836844277231612E-07 0.000000000000000E+00 alpha(00000350)=0.000000000000000E+00 beta (00000351)=0.125507892580230E+02 gamma(00000351)=0.125507892580230E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 351 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000351)=0.000000000000000E+00 beta (00000352)=0.134336932288059E+02 gamma(00000352)=0.134336932288059E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 352 z1= 1 -.307199639606667E-07 0.000000000000000E+00 z1= 2 0.143634992528279E-02 0.000000000000000E+00 z1= 3 0.881146036572694E-07 0.000000000000000E+00 alpha(00000352)=0.000000000000000E+00 beta (00000353)=0.129530404102140E+02 gamma(00000353)=0.129530404102140E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 353 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000353)=0.000000000000000E+00 beta (00000354)=0.132884545812135E+02 gamma(00000354)=0.132884545812135E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 354 z1= 1 0.288813327186180E-07 0.000000000000000E+00 z1= 2 -.157629215101497E-02 0.000000000000000E+00 z1= 3 -.941766341018384E-07 0.000000000000000E+00 alpha(00000354)=0.000000000000000E+00 beta (00000355)=0.124741653661665E+02 gamma(00000355)=0.124741653661665E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 355 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000355)=0.000000000000000E+00 beta (00000356)=0.136132713717855E+02 gamma(00000356)=0.136132713717855E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 356 z1= 1 -.254966142781976E-07 0.000000000000000E+00 z1= 2 0.166844381379463E-02 0.000000000000000E+00 z1= 3 0.955799756727172E-07 0.000000000000000E+00 alpha(00000356)=0.000000000000000E+00 beta (00000357)=0.128737361062631E+02 gamma(00000357)=0.128737361062631E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 357 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000357)=0.000000000000000E+00 beta (00000358)=0.136862069349042E+02 gamma(00000358)=0.136862069349042E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 358 z1= 1 0.209052696664019E-07 0.000000000000000E+00 z1= 2 -.178749099967038E-02 0.000000000000000E+00 z1= 3 -.935259798201917E-07 0.000000000000000E+00 alpha(00000358)=0.000000000000000E+00 beta (00000359)=0.126589861565586E+02 gamma(00000359)=0.126589861565586E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 359 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000359)=0.000000000000000E+00 beta (00000360)=0.138519004489014E+02 gamma(00000360)=0.138519004489014E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 360 z1= 1 -.166759452089119E-07 0.000000000000000E+00 z1= 2 0.183617225126096E-02 0.000000000000000E+00 z1= 3 0.932293405363086E-07 0.000000000000000E+00 alpha(00000360)=0.000000000000000E+00 beta (00000361)=0.124137609700460E+02 gamma(00000361)=0.124137609700460E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 361 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000361)=0.000000000000000E+00 beta (00000362)=0.134319967443932E+02 gamma(00000362)=0.134319967443932E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 362 z1= 1 0.170760293240549E-07 0.000000000000000E+00 z1= 2 -.191603081009496E-02 0.000000000000000E+00 z1= 3 -.942807075766114E-07 0.000000000000000E+00 alpha(00000362)=0.000000000000000E+00 beta (00000363)=0.128802117068844E+02 gamma(00000363)=0.128802117068844E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 363 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000363)=0.000000000000000E+00 beta (00000364)=0.135105217135001E+02 gamma(00000364)=0.135105217135001E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 364 z1= 1 -.251426592184911E-07 0.000000000000000E+00 z1= 2 0.201945083420381E-02 0.000000000000000E+00 z1= 3 0.100286878012179E-06 0.000000000000000E+00 alpha(00000364)=0.000000000000000E+00 beta (00000365)=0.123005747857534E+02 gamma(00000365)=0.123005747857534E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 365 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000365)=0.000000000000000E+00 beta (00000366)=0.129057209478121E+02 gamma(00000366)=0.129057209478121E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 366 z1= 1 0.298872886933879E-07 0.000000000000000E+00 z1= 2 -.211649905720781E-02 0.000000000000000E+00 z1= 3 -.107962472232397E-06 0.000000000000000E+00 alpha(00000366)=0.000000000000000E+00 beta (00000367)=0.127030946979589E+02 gamma(00000367)=0.127030946979589E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 367 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000367)=0.000000000000000E+00 beta (00000368)=0.134769699019453E+02 gamma(00000368)=0.134769699019453E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 368 z1= 1 -.311244338739580E-07 0.000000000000000E+00 z1= 2 0.214971635178473E-02 0.000000000000000E+00 z1= 3 0.109491179456952E-06 0.000000000000000E+00 alpha(00000368)=0.000000000000000E+00 beta (00000369)=0.125630516245039E+02 gamma(00000369)=0.125630516245039E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 369 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000369)=0.000000000000000E+00 beta (00000370)=0.133686461941152E+02 gamma(00000370)=0.133686461941152E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 370 z1= 1 0.304190263481635E-07 0.000000000000000E+00 z1= 2 -.212476989467473E-02 0.000000000000000E+00 z1= 3 -.105981799328387E-06 0.000000000000000E+00 alpha(00000370)=0.000000000000000E+00 beta (00000371)=0.128831595056249E+02 gamma(00000371)=0.128831595056249E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 371 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000371)=0.000000000000000E+00 beta (00000372)=0.133106363842040E+02 gamma(00000372)=0.133106363842040E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 372 z1= 1 -.343852544736067E-07 0.000000000000000E+00 z1= 2 0.214625477645100E-02 0.000000000000000E+00 z1= 3 0.102967947277703E-06 0.000000000000000E+00 alpha(00000372)=0.000000000000000E+00 beta (00000373)=0.128996765197312E+02 gamma(00000373)=0.128996765197312E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 373 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000373)=0.000000000000000E+00 beta (00000374)=0.136447955647200E+02 gamma(00000374)=0.136447955647200E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 374 z1= 1 0.255006458180565E-07 0.000000000000000E+00 z1= 2 -.207011913562906E-02 0.000000000000000E+00 z1= 3 -.100207887414913E-06 0.000000000000000E+00 alpha(00000374)=0.000000000000000E+00 beta (00000375)=0.128464976316194E+02 gamma(00000375)=0.128464976316194E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 375 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000375)=0.000000000000000E+00 beta (00000376)=0.131826076251388E+02 gamma(00000376)=0.131826076251388E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 376 z1= 1 -.264209636642934E-07 0.000000000000000E+00 z1= 2 0.196684364546119E-02 0.000000000000000E+00 z1= 3 0.997873976111294E-07 0.000000000000000E+00 alpha(00000376)=0.000000000000000E+00 beta (00000377)=0.130309444324210E+02 gamma(00000377)=0.130309444324210E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 377 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000377)=0.000000000000000E+00 beta (00000378)=0.135757054485861E+02 gamma(00000378)=0.135757054485861E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 378 z1= 1 0.173320598298790E-07 0.000000000000000E+00 z1= 2 -.175903361054547E-02 0.000000000000000E+00 z1= 3 -.103631653351473E-06 0.000000000000000E+00 alpha(00000378)=0.000000000000000E+00 beta (00000379)=0.125827946131479E+02 gamma(00000379)=0.125827946131479E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 379 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000379)=0.000000000000000E+00 beta (00000380)=0.133811898038207E+02 gamma(00000380)=0.133811898038207E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 380 z1= 1 -.210194955221725E-07 0.000000000000000E+00 z1= 2 0.146860718896092E-02 0.000000000000000E+00 z1= 3 0.104624349686871E-06 0.000000000000000E+00 alpha(00000380)=0.000000000000000E+00 beta (00000381)=0.131036671576469E+02 gamma(00000381)=0.131036671576469E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 381 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000381)=0.000000000000000E+00 beta (00000382)=0.134412107976734E+02 gamma(00000382)=0.134412107976734E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 382 z1= 1 0.182742414464587E-07 0.000000000000000E+00 z1= 2 -.127641440020401E-02 0.000000000000000E+00 z1= 3 -.114097170618942E-06 0.000000000000000E+00 alpha(00000382)=0.000000000000000E+00 beta (00000383)=0.129348317192728E+02 gamma(00000383)=0.129348317192728E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 383 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000383)=0.000000000000000E+00 beta (00000384)=0.134947074425347E+02 gamma(00000384)=0.134947074425347E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 384 z1= 1 -.236155732729476E-07 0.000000000000000E+00 z1= 2 0.111016718470753E-02 0.000000000000000E+00 z1= 3 0.116029586433222E-06 0.000000000000000E+00 alpha(00000384)=0.000000000000000E+00 beta (00000385)=0.126540227360431E+02 gamma(00000385)=0.126540227360431E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 385 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000385)=0.000000000000000E+00 beta (00000386)=0.130168220307546E+02 gamma(00000386)=0.130168220307546E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 386 z1= 1 0.240514123383065E-07 0.000000000000000E+00 z1= 2 -.966853748153478E-03 0.000000000000000E+00 z1= 3 -.121862478548495E-06 0.000000000000000E+00 alpha(00000386)=0.000000000000000E+00 beta (00000387)=0.129056943302618E+02 gamma(00000387)=0.129056943302618E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 387 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000387)=0.000000000000000E+00 beta (00000388)=0.133581502575045E+02 gamma(00000388)=0.133581502575045E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 388 z1= 1 -.290560447126220E-07 0.000000000000000E+00 z1= 2 0.838083530493906E-03 0.000000000000000E+00 z1= 3 0.122389660344975E-06 0.000000000000000E+00 alpha(00000388)=0.000000000000000E+00 beta (00000389)=0.125856367591486E+02 gamma(00000389)=0.125856367591486E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 389 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000389)=0.000000000000000E+00 beta (00000390)=0.134758440834964E+02 gamma(00000390)=0.134758440834964E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 390 z1= 1 0.270498268883750E-07 0.000000000000000E+00 z1= 2 -.729850912378196E-03 0.000000000000000E+00 z1= 3 -.122417460814476E-06 0.000000000000000E+00 alpha(00000390)=0.000000000000000E+00 beta (00000391)=0.129065526962456E+02 gamma(00000391)=0.129065526962456E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 391 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000391)=0.000000000000000E+00 beta (00000392)=0.131956502350641E+02 gamma(00000392)=0.131956502350641E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 392 z1= 1 -.309338165391075E-07 0.000000000000000E+00 z1= 2 0.744169437015942E-03 0.000000000000000E+00 z1= 3 0.125227743054575E-06 0.000000000000000E+00 alpha(00000392)=0.000000000000000E+00 beta (00000393)=0.126539186766206E+02 gamma(00000393)=0.126539186766206E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 393 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000393)=0.000000000000000E+00 beta (00000394)=0.133844467212367E+02 gamma(00000394)=0.133844467212367E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 394 z1= 1 0.303127646785611E-07 0.000000000000000E+00 z1= 2 -.721123831883925E-03 0.000000000000000E+00 z1= 3 -.126157584639272E-06 0.000000000000000E+00 alpha(00000394)=0.000000000000000E+00 beta (00000395)=0.126879519357944E+02 gamma(00000395)=0.126879519357944E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 395 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000395)=0.000000000000000E+00 beta (00000396)=0.132038449032282E+02 gamma(00000396)=0.132038449032282E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 396 z1= 1 -.329806693886471E-07 0.000000000000000E+00 z1= 2 0.632840642440768E-03 0.000000000000000E+00 z1= 3 0.125593796112991E-06 0.000000000000000E+00 alpha(00000396)=0.000000000000000E+00 beta (00000397)=0.127102187797759E+02 gamma(00000397)=0.127102187797759E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 397 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000397)=0.000000000000000E+00 beta (00000398)=0.131584529287281E+02 gamma(00000398)=0.131584529287281E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 398 z1= 1 0.371502371756052E-07 0.000000000000000E+00 z1= 2 -.428769330838305E-03 0.000000000000000E+00 z1= 3 -.127334928595973E-06 0.000000000000000E+00 alpha(00000398)=0.000000000000000E+00 beta (00000399)=0.126871706225832E+02 gamma(00000399)=0.126871706225832E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 399 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000399)=0.000000000000000E+00 beta (00000400)=0.136082789930926E+02 gamma(00000400)=0.136082789930926E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 400 z1= 1 -.372195740590622E-07 0.000000000000000E+00 z1= 2 0.187584766050733E-03 0.000000000000000E+00 z1= 3 0.121629778938805E-06 0.000000000000000E+00 alpha(00000400)=0.000000000000000E+00 beta (00000401)=0.128724897838396E+02 gamma(00000401)=0.128724897838396E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 401 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000401)=0.000000000000000E+00 beta (00000402)=0.132282199083443E+02 gamma(00000402)=0.132282199083443E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 402 z1= 1 0.374680904037181E-07 0.000000000000000E+00 z1= 2 0.859252174472032E-04 0.000000000000000E+00 z1= 3 -.124753784336816E-06 0.000000000000000E+00 alpha(00000402)=0.000000000000000E+00 beta (00000403)=0.129669936527819E+02 gamma(00000403)=0.129669936527819E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 403 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000403)=0.000000000000000E+00 beta (00000404)=0.133474504279445E+02 gamma(00000404)=0.133474504279445E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 404 z1= 1 -.347092051476185E-07 0.000000000000000E+00 z1= 2 -.282962249603218E-03 0.000000000000000E+00 z1= 3 0.129294946385429E-06 0.000000000000000E+00 alpha(00000404)=0.000000000000000E+00 beta (00000405)=0.126597769685262E+02 gamma(00000405)=0.126597769685262E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 405 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000405)=0.000000000000000E+00 beta (00000406)=0.135479223170250E+02 gamma(00000406)=0.135479223170250E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 406 z1= 1 0.350752989920940E-07 0.000000000000000E+00 z1= 2 0.447898394911675E-03 0.000000000000000E+00 z1= 3 -.131774293583463E-06 0.000000000000000E+00 alpha(00000406)=0.000000000000000E+00 beta (00000407)=0.127122172852972E+02 gamma(00000407)=0.127122172852972E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 407 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000407)=0.000000000000000E+00 beta (00000408)=0.130765080929129E+02 gamma(00000408)=0.130765080929129E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 408 z1= 1 -.324974650093603E-07 0.000000000000000E+00 z1= 2 -.688699196757458E-03 0.000000000000000E+00 z1= 3 0.133801305831184E-06 0.000000000000000E+00 alpha(00000408)=0.000000000000000E+00 beta (00000409)=0.129438321526658E+02 gamma(00000409)=0.129438321526658E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 409 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000409)=0.000000000000000E+00 beta (00000410)=0.133585502505342E+02 gamma(00000410)=0.133585502505342E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 410 z1= 1 0.345192217201910E-07 0.000000000000000E+00 z1= 2 0.928764181369387E-03 0.000000000000000E+00 z1= 3 -.136373092621928E-06 0.000000000000000E+00 alpha(00000410)=0.000000000000000E+00 beta (00000411)=0.128082036138832E+02 gamma(00000411)=0.128082036138832E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 411 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000411)=0.000000000000000E+00 beta (00000412)=0.138151174771121E+02 gamma(00000412)=0.138151174771121E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 412 z1= 1 -.344135909912009E-07 0.000000000000000E+00 z1= 2 -.106258492657013E-02 0.000000000000000E+00 z1= 3 0.136228702510489E-06 0.000000000000000E+00 alpha(00000412)=0.000000000000000E+00 beta (00000413)=0.124503914993349E+02 gamma(00000413)=0.124503914993349E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 413 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000413)=0.000000000000000E+00 beta (00000414)=0.133781979592509E+02 gamma(00000414)=0.133781979592509E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 414 z1= 1 0.378717393682317E-07 0.000000000000000E+00 z1= 2 0.111328939897484E-02 0.000000000000000E+00 z1= 3 -.135051871047481E-06 0.000000000000000E+00 alpha(00000414)=0.000000000000000E+00 beta (00000415)=0.130602888566273E+02 gamma(00000415)=0.130602888566273E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 415 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000415)=0.000000000000000E+00 beta (00000416)=0.135240136265773E+02 gamma(00000416)=0.135240136265773E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 416 z1= 1 -.363215338363646E-07 0.000000000000000E+00 z1= 2 -.106470587443794E-02 0.000000000000000E+00 z1= 3 0.139352483004271E-06 0.000000000000000E+00 alpha(00000416)=0.000000000000000E+00 beta (00000417)=0.126267854792101E+02 gamma(00000417)=0.126267854792101E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 417 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000417)=0.000000000000000E+00 beta (00000418)=0.138149863952634E+02 gamma(00000418)=0.138149863952634E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 418 z1= 1 0.392393495721351E-07 0.000000000000000E+00 z1= 2 0.854492673844777E-03 0.000000000000000E+00 z1= 3 -.132927468343897E-06 0.000000000000000E+00 alpha(00000418)=0.000000000000000E+00 beta (00000419)=0.126628276132218E+02 gamma(00000419)=0.126628276132218E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 419 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000419)=0.000000000000000E+00 beta (00000420)=0.135328845044111E+02 gamma(00000420)=0.135328845044111E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 420 z1= 1 -.390159106498228E-07 0.000000000000000E+00 z1= 2 -.678565467407017E-03 0.000000000000000E+00 z1= 3 0.130590896556498E-06 0.000000000000000E+00 alpha(00000420)=0.000000000000000E+00 beta (00000421)=0.128435861489510E+02 gamma(00000421)=0.128435861489510E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 421 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000421)=0.000000000000000E+00 beta (00000422)=0.130977003455654E+02 gamma(00000422)=0.130977003455654E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 422 z1= 1 0.448146104626776E-07 0.000000000000000E+00 z1= 2 0.619982546537924E-03 0.000000000000000E+00 z1= 3 -.137458779861529E-06 0.000000000000000E+00 alpha(00000422)=0.000000000000000E+00 beta (00000423)=0.127549537206725E+02 gamma(00000423)=0.127549537206725E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 423 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000423)=0.000000000000000E+00 beta (00000424)=0.136021882621118E+02 gamma(00000424)=0.136021882621118E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 424 z1= 1 -.407038511854307E-07 0.000000000000000E+00 z1= 2 -.545782954189021E-03 0.000000000000000E+00 z1= 3 0.136979512672334E-06 0.000000000000000E+00 alpha(00000424)=0.000000000000000E+00 beta (00000425)=0.123516461997034E+02 gamma(00000425)=0.123516461997034E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 425 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000425)=0.000000000000000E+00 beta (00000426)=0.137420385403743E+02 gamma(00000426)=0.137420385403743E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 426 z1= 1 0.398448857311107E-07 0.000000000000000E+00 z1= 2 0.419965417859533E-03 0.000000000000000E+00 z1= 3 -.125848882275362E-06 0.000000000000000E+00 alpha(00000426)=0.000000000000000E+00 beta (00000427)=0.127422130220607E+02 gamma(00000427)=0.127422130220607E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 427 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000427)=0.000000000000000E+00 beta (00000428)=0.133036718404293E+02 gamma(00000428)=0.133036718404293E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 428 z1= 1 -.359415195478816E-07 0.000000000000000E+00 z1= 2 -.210584191826303E-03 0.000000000000000E+00 z1= 3 0.126499788051851E-06 0.000000000000000E+00 alpha(00000428)=0.000000000000000E+00 beta (00000429)=0.128359407410149E+02 gamma(00000429)=0.128359407410149E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 429 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000429)=0.000000000000000E+00 beta (00000430)=0.132090842544582E+02 gamma(00000430)=0.132090842544582E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 430 z1= 1 0.353305068031412E-07 0.000000000000000E+00 z1= 2 -.143468903110504E-03 0.000000000000000E+00 z1= 3 -.131094923563478E-06 0.000000000000000E+00 alpha(00000430)=0.000000000000000E+00 beta (00000431)=0.129466043261655E+02 gamma(00000431)=0.129466043261655E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 431 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000431)=0.000000000000000E+00 beta (00000432)=0.135200569773105E+02 gamma(00000432)=0.135200569773105E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 432 z1= 1 -.331944856653971E-07 0.000000000000000E+00 z1= 2 0.471631893695326E-03 0.000000000000000E+00 z1= 3 0.135147483532722E-06 0.000000000000000E+00 alpha(00000432)=0.000000000000000E+00 beta (00000433)=0.125894267473813E+02 gamma(00000433)=0.125894267473813E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 433 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000433)=0.000000000000000E+00 beta (00000434)=0.137829711096880E+02 gamma(00000434)=0.137829711096880E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 434 z1= 1 0.323936618050469E-07 0.000000000000000E+00 z1= 2 -.700702529238496E-03 0.000000000000000E+00 z1= 3 -.126361803845867E-06 0.000000000000000E+00 alpha(00000434)=0.000000000000000E+00 beta (00000435)=0.128853809067472E+02 gamma(00000435)=0.128853809067472E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 435 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000435)=0.000000000000000E+00 beta (00000436)=0.132258485248767E+02 gamma(00000436)=0.132258485248767E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 436 z1= 1 -.339619629701957E-07 0.000000000000000E+00 z1= 2 0.901031875849759E-03 0.000000000000000E+00 z1= 3 0.132655100563305E-06 0.000000000000000E+00 alpha(00000436)=0.000000000000000E+00 beta (00000437)=0.129075896854954E+02 gamma(00000437)=0.129075896854954E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 437 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000437)=0.000000000000000E+00 beta (00000438)=0.128552976176077E+02 gamma(00000438)=0.128552976176077E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 438 z1= 1 0.369725958867737E-07 0.000000000000000E+00 z1= 2 -.935134001781069E-03 0.000000000000000E+00 z1= 3 -.147164135677689E-06 0.000000000000000E+00 alpha(00000438)=0.000000000000000E+00 beta (00000439)=0.127812161115547E+02 gamma(00000439)=0.127812161115547E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 439 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000439)=0.000000000000000E+00 beta (00000440)=0.133198573041575E+02 gamma(00000440)=0.133198573041575E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 440 z1= 1 -.393208918498394E-07 0.000000000000000E+00 z1= 2 0.809274482390331E-03 0.000000000000000E+00 z1= 3 0.149740349131679E-06 0.000000000000000E+00 alpha(00000440)=0.000000000000000E+00 beta (00000441)=0.124650111029285E+02 gamma(00000441)=0.124650111029285E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 441 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000441)=0.000000000000000E+00 beta (00000442)=0.134801114389943E+02 gamma(00000442)=0.134801114389943E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 442 z1= 1 0.425098126352608E-07 0.000000000000000E+00 z1= 2 -.514588141111738E-03 0.000000000000000E+00 z1= 3 -.147359263467321E-06 0.000000000000000E+00 alpha(00000442)=0.000000000000000E+00 beta (00000443)=0.125914931768032E+02 gamma(00000443)=0.125914931768032E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 443 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000443)=0.000000000000000E+00 beta (00000444)=0.133360282114310E+02 gamma(00000444)=0.133360282114310E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 444 z1= 1 -.427901042073311E-07 0.000000000000000E+00 z1= 2 0.178374536862728E-03 0.000000000000000E+00 z1= 3 0.147413739054068E-06 0.000000000000000E+00 alpha(00000444)=0.000000000000000E+00 beta (00000445)=0.132106428042893E+02 gamma(00000445)=0.132106428042893E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 445 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000445)=0.000000000000000E+00 beta (00000446)=0.130293023286736E+02 gamma(00000446)=0.130293023286736E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 446 z1= 1 0.450633481814677E-07 0.000000000000000E+00 z1= 2 0.132391684802101E-03 0.000000000000000E+00 z1= 3 -.160851398799794E-06 0.000000000000000E+00 alpha(00000446)=0.000000000000000E+00 beta (00000447)=0.129510245592386E+02 gamma(00000447)=0.129510245592386E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 447 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000447)=0.000000000000000E+00 beta (00000448)=0.132109992354865E+02 gamma(00000448)=0.132109992354865E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 448 z1= 1 -.443349486888359E-07 0.000000000000000E+00 z1= 2 -.346151287820146E-03 0.000000000000000E+00 z1= 3 0.165300268813688E-06 0.000000000000000E+00 alpha(00000448)=0.000000000000000E+00 beta (00000449)=0.129466941079390E+02 gamma(00000449)=0.129466941079390E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 449 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000449)=0.000000000000000E+00 beta (00000450)=0.136530018926225E+02 gamma(00000450)=0.136530018926225E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 450 z1= 1 0.449676460711687E-07 0.000000000000000E+00 z1= 2 0.464368376514675E-03 0.000000000000000E+00 z1= 3 -.166524626078323E-06 0.000000000000000E+00 alpha(00000450)=0.000000000000000E+00 beta (00000451)=0.124487299062868E+02 gamma(00000451)=0.124487299062868E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 451 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000451)=0.000000000000000E+00 beta (00000452)=0.137444303144648E+02 gamma(00000452)=0.137444303144648E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 452 z1= 1 -.487236363980875E-07 0.000000000000000E+00 z1= 2 -.623583984982846E-03 0.000000000000000E+00 z1= 3 0.158556507239211E-06 0.000000000000000E+00 alpha(00000452)=0.000000000000000E+00 beta (00000453)=0.123492808386326E+02 gamma(00000453)=0.123492808386326E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 453 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000453)=0.000000000000000E+00 beta (00000454)=0.136339950055322E+02 gamma(00000454)=0.136339950055322E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 454 z1= 1 0.555237286989710E-07 0.000000000000000E+00 z1= 2 0.742638597958248E-03 0.000000000000000E+00 z1= 3 -.155081031853808E-06 0.000000000000000E+00 alpha(00000454)=0.000000000000000E+00 beta (00000455)=0.124956440496036E+02 gamma(00000455)=0.124956440496036E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 455 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000455)=0.000000000000000E+00 beta (00000456)=0.136121480630210E+02 gamma(00000456)=0.136121480630210E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 456 z1= 1 -.665396360970474E-07 0.000000000000000E+00 z1= 2 -.938373755309610E-03 0.000000000000000E+00 z1= 3 0.154351108915229E-06 0.000000000000000E+00 alpha(00000456)=0.000000000000000E+00 beta (00000457)=0.127309869503729E+02 gamma(00000457)=0.127309869503729E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 457 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000457)=0.000000000000000E+00 beta (00000458)=0.134655823219558E+02 gamma(00000458)=0.134655823219558E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 458 z1= 1 0.697758295638978E-07 0.000000000000000E+00 z1= 2 0.110848602306167E-02 0.000000000000000E+00 z1= 3 -.155650483552521E-06 0.000000000000000E+00 alpha(00000458)=0.000000000000000E+00 beta (00000459)=0.129367228338878E+02 gamma(00000459)=0.129367228338878E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 459 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000459)=0.000000000000000E+00 beta (00000460)=0.134364011415078E+02 gamma(00000460)=0.134364011415078E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 460 z1= 1 -.746810847104123E-07 0.000000000000000E+00 z1= 2 -.121737284041820E-02 0.000000000000000E+00 z1= 3 0.158485006514003E-06 0.000000000000000E+00 alpha(00000460)=0.000000000000000E+00 beta (00000461)=0.127154402569361E+02 gamma(00000461)=0.127154402569361E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 461 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000461)=0.000000000000000E+00 beta (00000462)=0.133070829181893E+02 gamma(00000462)=0.133070829181893E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 462 z1= 1 0.696737849662996E-07 0.000000000000000E+00 z1= 2 0.123503078623346E-02 0.000000000000000E+00 z1= 3 -.156709739538370E-06 0.000000000000000E+00 alpha(00000462)=0.000000000000000E+00 beta (00000463)=0.130283951906803E+02 gamma(00000463)=0.130283951906803E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 463 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000463)=0.000000000000000E+00 beta (00000464)=0.134222248286594E+02 gamma(00000464)=0.134222248286594E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 464 z1= 1 -.740138333429723E-07 0.000000000000000E+00 z1= 2 -.114392947946990E-02 0.000000000000000E+00 z1= 3 0.158995482132810E-06 0.000000000000000E+00 alpha(00000464)=0.000000000000000E+00 beta (00000465)=0.126548165933917E+02 gamma(00000465)=0.126548165933917E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 465 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000465)=0.000000000000000E+00 beta (00000466)=0.134462814075408E+02 gamma(00000466)=0.134462814075408E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 466 z1= 1 0.707128025374988E-07 0.000000000000000E+00 z1= 2 0.998944812946896E-03 0.000000000000000E+00 z1= 3 -.154292796365047E-06 0.000000000000000E+00 alpha(00000466)=0.000000000000000E+00 beta (00000467)=0.128133580841480E+02 gamma(00000467)=0.128133580841480E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 467 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000467)=0.000000000000000E+00 beta (00000468)=0.136879992161675E+02 gamma(00000468)=0.136879992161675E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 468 z1= 1 -.708740909935055E-07 0.000000000000000E+00 z1= 2 -.835321743302163E-03 0.000000000000000E+00 z1= 3 0.148184530257745E-06 0.000000000000000E+00 alpha(00000468)=0.000000000000000E+00 beta (00000469)=0.126931048812775E+02 gamma(00000469)=0.126931048812775E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 469 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000469)=0.000000000000000E+00 beta (00000470)=0.136809087722659E+02 gamma(00000470)=0.136809087722659E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 470 z1= 1 0.586884691418767E-07 0.000000000000000E+00 z1= 2 0.600309031381090E-03 0.000000000000000E+00 z1= 3 -.148038234876405E-06 0.000000000000000E+00 alpha(00000470)=0.000000000000000E+00 beta (00000471)=0.127568955932717E+02 gamma(00000471)=0.127568955932717E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 471 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000471)=0.000000000000000E+00 beta (00000472)=0.133840171224934E+02 gamma(00000472)=0.133840171224934E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 472 z1= 1 -.578699247335158E-07 0.000000000000000E+00 z1= 2 -.373833000182367E-03 0.000000000000000E+00 z1= 3 0.153695993641175E-06 0.000000000000000E+00 alpha(00000472)=0.000000000000000E+00 beta (00000473)=0.126367610986396E+02 gamma(00000473)=0.126367610986396E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 473 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000473)=0.000000000000000E+00 beta (00000474)=0.134963119814422E+02 gamma(00000474)=0.134963119814422E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 474 z1= 1 0.529982353504512E-07 0.000000000000000E+00 z1= 2 0.135702472486053E-03 0.000000000000000E+00 z1= 3 -.154527805467110E-06 0.000000000000000E+00 alpha(00000474)=0.000000000000000E+00 beta (00000475)=0.127396974834226E+02 gamma(00000475)=0.127396974834226E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 475 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000475)=0.000000000000000E+00 beta (00000476)=0.133045815784773E+02 gamma(00000476)=0.133045815784773E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 476 z1= 1 -.562293457667846E-07 0.000000000000000E+00 z1= 2 -.951959050821301E-06 0.000000000000000E+00 z1= 3 0.157500722973534E-06 0.000000000000000E+00 alpha(00000476)=0.000000000000000E+00 beta (00000477)=0.126413677607881E+02 gamma(00000477)=0.126413677607881E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 477 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000477)=0.000000000000000E+00 beta (00000478)=0.133309760285292E+02 gamma(00000478)=0.133309760285292E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 478 z1= 1 0.599905409567197E-07 0.000000000000000E+00 z1= 2 -.917917294545956E-04 0.000000000000000E+00 z1= 3 -.159623682443699E-06 0.000000000000000E+00 alpha(00000478)=0.000000000000000E+00 beta (00000479)=0.126278808285764E+02 gamma(00000479)=0.126278808285764E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 479 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000479)=0.000000000000000E+00 beta (00000480)=0.133938903733732E+02 gamma(00000480)=0.133938903733732E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 480 z1= 1 -.595184816362671E-07 0.000000000000000E+00 z1= 2 0.173565370947166E-03 0.000000000000000E+00 z1= 3 0.168323650770073E-06 0.000000000000000E+00 alpha(00000480)=0.000000000000000E+00 beta (00000481)=0.126436586202042E+02 gamma(00000481)=0.126436586202042E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 481 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000481)=0.000000000000000E+00 beta (00000482)=0.134765933805386E+02 gamma(00000482)=0.134765933805386E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 482 z1= 1 0.567477902711257E-07 0.000000000000000E+00 z1= 2 -.277319089721708E-03 0.000000000000000E+00 z1= 3 -.172765991277729E-06 0.000000000000000E+00 alpha(00000482)=0.000000000000000E+00 beta (00000483)=0.127038185865252E+02 gamma(00000483)=0.127038185865252E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 483 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000483)=0.000000000000000E+00 beta (00000484)=0.136555925883466E+02 gamma(00000484)=0.136555925883466E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 484 z1= 1 -.509386782403080E-07 0.000000000000000E+00 z1= 2 0.375820503197687E-03 0.000000000000000E+00 z1= 3 0.176166290355190E-06 0.000000000000000E+00 alpha(00000484)=0.000000000000000E+00 beta (00000485)=0.126726843076262E+02 gamma(00000485)=0.126726843076262E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 485 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000485)=0.000000000000000E+00 beta (00000486)=0.132370719123681E+02 gamma(00000486)=0.132370719123681E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 486 z1= 1 0.459331337483888E-07 0.000000000000000E+00 z1= 2 -.479677576727354E-03 0.000000000000000E+00 z1= 3 -.178445224259191E-06 0.000000000000000E+00 alpha(00000486)=0.000000000000000E+00 beta (00000487)=0.124437843643906E+02 gamma(00000487)=0.124437843643906E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 487 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000487)=0.000000000000000E+00 beta (00000488)=0.134506509552928E+02 gamma(00000488)=0.134506509552928E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 488 z1= 1 -.444666535685855E-07 0.000000000000000E+00 z1= 2 0.509274729724719E-03 0.000000000000000E+00 z1= 3 0.175101381610292E-06 0.000000000000000E+00 alpha(00000488)=0.000000000000000E+00 beta (00000489)=0.128389005118893E+02 gamma(00000489)=0.128389005118893E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 489 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000489)=0.000000000000000E+00 beta (00000490)=0.132662137403662E+02 gamma(00000490)=0.132662137403662E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 490 z1= 1 0.488399404083469E-07 0.000000000000000E+00 z1= 2 -.578702001397243E-03 0.000000000000000E+00 z1= 3 -.175888557188647E-06 0.000000000000000E+00 alpha(00000490)=0.000000000000000E+00 beta (00000491)=0.125996018379996E+02 gamma(00000491)=0.125996018379996E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 491 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000491)=0.000000000000000E+00 beta (00000492)=0.134509573342020E+02 gamma(00000492)=0.134509573342020E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 492 z1= 1 -.472561954741046E-07 0.000000000000000E+00 z1= 2 0.651038473067959E-03 0.000000000000000E+00 z1= 3 0.175563270607014E-06 0.000000000000000E+00 alpha(00000492)=0.000000000000000E+00 beta (00000493)=0.127244136594905E+02 gamma(00000493)=0.127244136594905E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 493 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000493)=0.000000000000000E+00 beta (00000494)=0.132869531090573E+02 gamma(00000494)=0.132869531090573E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 494 z1= 1 0.562000610423996E-07 0.000000000000000E+00 z1= 2 -.800553840526839E-03 0.000000000000000E+00 z1= 3 -.177199835599371E-06 0.000000000000000E+00 alpha(00000494)=0.000000000000000E+00 beta (00000495)=0.124536296169964E+02 gamma(00000495)=0.124536296169964E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 495 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000495)=0.000000000000000E+00 beta (00000496)=0.134976889061841E+02 gamma(00000496)=0.134976889061841E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 496 z1= 1 -.571679578294237E-07 0.000000000000000E+00 z1= 2 0.850564038847641E-03 0.000000000000000E+00 z1= 3 0.182843166313888E-06 0.000000000000000E+00 alpha(00000496)=0.000000000000000E+00 beta (00000497)=0.128392395478453E+02 gamma(00000497)=0.128392395478453E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 497 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000497)=0.000000000000000E+00 beta (00000498)=0.133354166640412E+02 gamma(00000498)=0.133354166640412E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 498 z1= 1 0.724790626882230E-07 0.000000000000000E+00 z1= 2 -.921245581343311E-03 0.000000000000000E+00 z1= 3 -.192717288609898E-06 0.000000000000000E+00 alpha(00000498)=0.000000000000000E+00 beta (00000499)=0.126817449693445E+02 gamma(00000499)=0.126817449693445E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 499 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000499)=0.000000000000000E+00 beta (00000500)=0.134574927911981E+02 gamma(00000500)=0.134574927911981E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 500 z1= 1 -.654818752723711E-07 0.000000000000000E+00 z1= 2 0.105538741163808E-02 0.000000000000000E+00 z1= 3 0.205072208913411E-06 0.000000000000000E+00 alpha(00000500)=0.000000000000000E+00 beta (00000501)=0.127050115448817E+02 gamma(00000501)=0.127050115448817E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Norm of initial Lanczos vectors= 1.841315029262760 Starting Lanczos loop 3 Lanczos iteration: 1 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal alpha(00000001)=0.000000000000000E+00 beta (00000002)=0.172013904561725E+01 gamma(00000002)=0.172013904561725E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 2 z1= 1 0.273451502350876E-06 0.000000000000000E+00 z1= 2 -.139126216262017E-06 0.000000000000000E+00 z1= 3 0.124507722952914E+01 0.000000000000000E+00 alpha(00000002)=0.000000000000000E+00 beta (00000003)=0.476624363080500E+01 gamma(00000003)=0.476624363080500E+01 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 3 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000003)=0.000000000000000E+00 beta (00000004)=0.135459630258080E+02 gamma(00000004)=0.135459630258080E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 4 z1= 1 -.830173304535928E-07 0.000000000000000E+00 z1= 2 0.490485095765224E-07 0.000000000000000E+00 z1= 3 -.355850995478065E+00 0.000000000000000E+00 alpha(00000004)=0.000000000000000E+00 beta (00000005)=0.127188561247574E+02 gamma(00000005)=0.127188561247574E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 5 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000005)=0.000000000000000E+00 beta (00000006)=0.134777625998898E+02 gamma(00000006)=0.134777625998898E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 6 z1= 1 0.789934392321175E-07 0.000000000000000E+00 z1= 2 -.461288734788365E-07 0.000000000000000E+00 z1= 3 0.303388701635848E+00 0.000000000000000E+00 alpha(00000006)=0.000000000000000E+00 beta (00000007)=0.128882496019527E+02 gamma(00000007)=0.128882496019527E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 7 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000007)=0.000000000000000E+00 beta (00000008)=0.133738540377034E+02 gamma(00000008)=0.133738540377034E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 8 z1= 1 -.797725311786732E-07 0.000000000000000E+00 z1= 2 0.494839210421667E-07 0.000000000000000E+00 z1= 3 -.273843927573867E+00 0.000000000000000E+00 alpha(00000008)=0.000000000000000E+00 beta (00000009)=0.128589240575659E+02 gamma(00000009)=0.128589240575659E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 9 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000009)=0.000000000000000E+00 beta (00000010)=0.134144083723653E+02 gamma(00000010)=0.134144083723653E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 10 z1= 1 0.800746700369307E-07 0.000000000000000E+00 z1= 2 -.546843283599665E-07 0.000000000000000E+00 z1= 3 0.250112050326558E+00 0.000000000000000E+00 alpha(00000010)=0.000000000000000E+00 beta (00000011)=0.128243168940879E+02 gamma(00000011)=0.128243168940879E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 11 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000011)=0.000000000000000E+00 beta (00000012)=0.134765058033377E+02 gamma(00000012)=0.134765058033377E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 12 z1= 1 -.817230630854003E-07 0.000000000000000E+00 z1= 2 0.580514351978216E-07 0.000000000000000E+00 z1= 3 -.228509368498393E+00 0.000000000000000E+00 alpha(00000012)=0.000000000000000E+00 beta (00000013)=0.128064940706699E+02 gamma(00000013)=0.128064940706699E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 13 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000013)=0.000000000000000E+00 beta (00000014)=0.134984076422244E+02 gamma(00000014)=0.134984076422244E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 14 z1= 1 0.872868327716873E-07 0.000000000000000E+00 z1= 2 -.611067529212797E-07 0.000000000000000E+00 z1= 3 0.209127967602933E+00 0.000000000000000E+00 alpha(00000014)=0.000000000000000E+00 beta (00000015)=0.128005640434677E+02 gamma(00000015)=0.128005640434677E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 15 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000015)=0.000000000000000E+00 beta (00000016)=0.134717438241025E+02 gamma(00000016)=0.134717438241025E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 16 z1= 1 -.963534495564003E-07 0.000000000000000E+00 z1= 2 0.622509892448774E-07 0.000000000000000E+00 z1= 3 -.192248851171821E+00 0.000000000000000E+00 alpha(00000016)=0.000000000000000E+00 beta (00000017)=0.127887249209951E+02 gamma(00000017)=0.127887249209951E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 17 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000017)=0.000000000000000E+00 beta (00000018)=0.134268158804725E+02 gamma(00000018)=0.134268158804725E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 18 z1= 1 0.107506715922210E-06 0.000000000000000E+00 z1= 2 -.584530228405459E-07 0.000000000000000E+00 z1= 3 0.177640858123541E+00 0.000000000000000E+00 alpha(00000018)=0.000000000000000E+00 beta (00000019)=0.127825849327317E+02 gamma(00000019)=0.127825849327317E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 19 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000019)=0.000000000000000E+00 beta (00000020)=0.134082303867143E+02 gamma(00000020)=0.134082303867143E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 20 z1= 1 -.117833524493783E-06 0.000000000000000E+00 z1= 2 0.547782496420002E-07 0.000000000000000E+00 z1= 3 -.164659692436931E+00 0.000000000000000E+00 alpha(00000020)=0.000000000000000E+00 beta (00000021)=0.128007456107050E+02 gamma(00000021)=0.128007456107050E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 21 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000021)=0.000000000000000E+00 beta (00000022)=0.134209321661699E+02 gamma(00000022)=0.134209321661699E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 22 z1= 1 0.122940840581627E-06 0.000000000000000E+00 z1= 2 -.539267914842630E-07 0.000000000000000E+00 z1= 3 0.153026583341774E+00 0.000000000000000E+00 alpha(00000022)=0.000000000000000E+00 beta (00000023)=0.128225908803370E+02 gamma(00000023)=0.128225908803370E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 23 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000023)=0.000000000000000E+00 beta (00000024)=0.134334878353125E+02 gamma(00000024)=0.134334878353125E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 24 z1= 1 -.132790666186621E-06 0.000000000000000E+00 z1= 2 0.569511751557838E-07 0.000000000000000E+00 z1= 3 -.142608255793704E+00 0.000000000000000E+00 alpha(00000024)=0.000000000000000E+00 beta (00000025)=0.128311475120321E+02 gamma(00000025)=0.128311475120321E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 25 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000025)=0.000000000000000E+00 beta (00000026)=0.134385685983726E+02 gamma(00000026)=0.134385685983726E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 26 z1= 1 0.141263267004928E-06 0.000000000000000E+00 z1= 2 -.631396176600465E-07 0.000000000000000E+00 z1= 3 0.133154053957179E+00 0.000000000000000E+00 alpha(00000026)=0.000000000000000E+00 beta (00000027)=0.128182411739205E+02 gamma(00000027)=0.128182411739205E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 27 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000027)=0.000000000000000E+00 beta (00000028)=0.134104207952885E+02 gamma(00000028)=0.134104207952885E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 28 z1= 1 -.145379245640107E-06 0.000000000000000E+00 z1= 2 0.687366293893900E-07 0.000000000000000E+00 z1= 3 -.124654469582845E+00 0.000000000000000E+00 alpha(00000028)=0.000000000000000E+00 beta (00000029)=0.127846982315936E+02 gamma(00000029)=0.127846982315936E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 29 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000029)=0.000000000000000E+00 beta (00000030)=0.134136253073170E+02 gamma(00000030)=0.134136253073170E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 30 z1= 1 0.150385208158316E-06 0.000000000000000E+00 z1= 2 -.706748803255787E-07 0.000000000000000E+00 z1= 3 0.116502230403242E+00 0.000000000000000E+00 alpha(00000030)=0.000000000000000E+00 beta (00000031)=0.128191856179325E+02 gamma(00000031)=0.128191856179325E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 31 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000031)=0.000000000000000E+00 beta (00000032)=0.134296071534019E+02 gamma(00000032)=0.134296071534019E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 32 z1= 1 -.155104579676354E-06 0.000000000000000E+00 z1= 2 0.751328699629046E-07 0.000000000000000E+00 z1= 3 -.109172836113373E+00 0.000000000000000E+00 alpha(00000032)=0.000000000000000E+00 beta (00000033)=0.127671478267701E+02 gamma(00000033)=0.127671478267701E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 33 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000033)=0.000000000000000E+00 beta (00000034)=0.133588565053291E+02 gamma(00000034)=0.133588565053291E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 34 z1= 1 0.156739861120574E-06 0.000000000000000E+00 z1= 2 -.825555415454276E-07 0.000000000000000E+00 z1= 3 0.102503263066306E+00 0.000000000000000E+00 alpha(00000034)=0.000000000000000E+00 beta (00000035)=0.127703439694412E+02 gamma(00000035)=0.127703439694412E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 35 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000035)=0.000000000000000E+00 beta (00000036)=0.134313018561542E+02 gamma(00000036)=0.134313018561542E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 36 z1= 1 -.154496511482792E-06 0.000000000000000E+00 z1= 2 0.824720144027057E-07 0.000000000000000E+00 z1= 3 -.958077274661318E-01 0.000000000000000E+00 alpha(00000036)=0.000000000000000E+00 beta (00000037)=0.128060730003906E+02 gamma(00000037)=0.128060730003906E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 37 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000037)=0.000000000000000E+00 beta (00000038)=0.133890904208971E+02 gamma(00000038)=0.133890904208971E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 38 z1= 1 0.152555289775758E-06 0.000000000000000E+00 z1= 2 -.818304169134573E-07 0.000000000000000E+00 z1= 3 0.901244120098112E-01 0.000000000000000E+00 alpha(00000038)=0.000000000000000E+00 beta (00000039)=0.127549834245475E+02 gamma(00000039)=0.127549834245475E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 39 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000039)=0.000000000000000E+00 beta (00000040)=0.133499001734211E+02 gamma(00000040)=0.133499001734211E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 40 z1= 1 -.150268537416672E-06 0.000000000000000E+00 z1= 2 0.843446079337089E-07 0.000000000000000E+00 z1= 3 -.847130062894432E-01 0.000000000000000E+00 alpha(00000040)=0.000000000000000E+00 beta (00000041)=0.126995604330439E+02 gamma(00000041)=0.126995604330439E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 41 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000041)=0.000000000000000E+00 beta (00000042)=0.133248690062622E+02 gamma(00000042)=0.133248690062622E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 42 z1= 1 0.149931374368107E-06 0.000000000000000E+00 z1= 2 -.842301219000456E-07 0.000000000000000E+00 z1= 3 0.794237454357324E-01 0.000000000000000E+00 alpha(00000042)=0.000000000000000E+00 beta (00000043)=0.127528770292067E+02 gamma(00000043)=0.127528770292067E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 43 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000043)=0.000000000000000E+00 beta (00000044)=0.133693943632333E+02 gamma(00000044)=0.133693943632333E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 44 z1= 1 -.149668856394168E-06 0.000000000000000E+00 z1= 2 0.856998112257700E-07 0.000000000000000E+00 z1= 3 -.745707238284820E-01 0.000000000000000E+00 alpha(00000044)=0.000000000000000E+00 beta (00000045)=0.127653091079188E+02 gamma(00000045)=0.127653091079188E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 45 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000045)=0.000000000000000E+00 beta (00000046)=0.134074089829389E+02 gamma(00000046)=0.134074089829389E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 46 z1= 1 0.149278915832557E-06 0.000000000000000E+00 z1= 2 -.872878282846584E-07 0.000000000000000E+00 z1= 3 0.698759014472529E-01 0.000000000000000E+00 alpha(00000046)=0.000000000000000E+00 beta (00000047)=0.127671431634507E+02 gamma(00000047)=0.127671431634507E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 47 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000047)=0.000000000000000E+00 beta (00000048)=0.133559378503177E+02 gamma(00000048)=0.133559378503177E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 48 z1= 1 -.153496462630036E-06 0.000000000000000E+00 z1= 2 0.906263678540761E-07 0.000000000000000E+00 z1= 3 -.657379695110327E-01 0.000000000000000E+00 alpha(00000048)=0.000000000000000E+00 beta (00000049)=0.128436476811353E+02 gamma(00000049)=0.128436476811353E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 49 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000049)=0.000000000000000E+00 beta (00000050)=0.134360452718781E+02 gamma(00000050)=0.134360452718781E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 50 z1= 1 0.156695589742560E-06 0.000000000000000E+00 z1= 2 -.917223314090925E-07 0.000000000000000E+00 z1= 3 0.618983054920555E-01 0.000000000000000E+00 alpha(00000050)=0.000000000000000E+00 beta (00000051)=0.126967719561303E+02 gamma(00000051)=0.126967719561303E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 51 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000051)=0.000000000000000E+00 beta (00000052)=0.132892772222019E+02 gamma(00000052)=0.132892772222019E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 52 z1= 1 -.158952048143115E-06 0.000000000000000E+00 z1= 2 0.963186191956639E-07 0.000000000000000E+00 z1= 3 -.582039303007598E-01 0.000000000000000E+00 alpha(00000052)=0.000000000000000E+00 beta (00000053)=0.127443746282948E+02 gamma(00000053)=0.127443746282948E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 53 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000053)=0.000000000000000E+00 beta (00000054)=0.133133388840469E+02 gamma(00000054)=0.133133388840469E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 54 z1= 1 0.160972844283130E-06 0.000000000000000E+00 z1= 2 -.103127555220125E-06 0.000000000000000E+00 z1= 3 0.548828842306493E-01 0.000000000000000E+00 alpha(00000054)=0.000000000000000E+00 beta (00000055)=0.127443755624109E+02 gamma(00000055)=0.127443755624109E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 55 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000055)=0.000000000000000E+00 beta (00000056)=0.133787252604853E+02 gamma(00000056)=0.133787252604853E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 56 z1= 1 -.165273455578381E-06 0.000000000000000E+00 z1= 2 0.101803983126267E-06 0.000000000000000E+00 z1= 3 -.515188630345457E-01 0.000000000000000E+00 alpha(00000056)=0.000000000000000E+00 beta (00000057)=0.128320488458196E+02 gamma(00000057)=0.128320488458196E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 57 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000057)=0.000000000000000E+00 beta (00000058)=0.134462106880130E+02 gamma(00000058)=0.134462106880130E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 58 z1= 1 0.167992524894005E-06 0.000000000000000E+00 z1= 2 -.964363430993416E-07 0.000000000000000E+00 z1= 3 0.484468361484987E-01 0.000000000000000E+00 alpha(00000058)=0.000000000000000E+00 beta (00000059)=0.127464619430298E+02 gamma(00000059)=0.127464619430298E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 59 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000059)=0.000000000000000E+00 beta (00000060)=0.133329413971354E+02 gamma(00000060)=0.133329413971354E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 60 z1= 1 -.167695623751879E-06 0.000000000000000E+00 z1= 2 0.900302045949363E-07 0.000000000000000E+00 z1= 3 -.456812185630258E-01 0.000000000000000E+00 alpha(00000060)=0.000000000000000E+00 beta (00000061)=0.128406177084230E+02 gamma(00000061)=0.128406177084230E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 61 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000061)=0.000000000000000E+00 beta (00000062)=0.133762263976796E+02 gamma(00000062)=0.133762263976796E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 62 z1= 1 0.169129343663118E-06 0.000000000000000E+00 z1= 2 -.871214968040871E-07 0.000000000000000E+00 z1= 3 0.432498539490117E-01 0.000000000000000E+00 alpha(00000062)=0.000000000000000E+00 beta (00000063)=0.128441567877142E+02 gamma(00000063)=0.128441567877142E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 63 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000063)=0.000000000000000E+00 beta (00000064)=0.134461685755595E+02 gamma(00000064)=0.134461685755595E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 64 z1= 1 -.171774690323158E-06 0.000000000000000E+00 z1= 2 0.902781330246215E-07 0.000000000000000E+00 z1= 3 -.407854410806936E-01 0.000000000000000E+00 alpha(00000064)=0.000000000000000E+00 beta (00000065)=0.128237831899571E+02 gamma(00000065)=0.128237831899571E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 65 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000065)=0.000000000000000E+00 beta (00000066)=0.134806310724154E+02 gamma(00000066)=0.134806310724154E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 66 z1= 1 0.172157336609342E-06 0.000000000000000E+00 z1= 2 -.990587935776048E-07 0.000000000000000E+00 z1= 3 0.383379825191875E-01 0.000000000000000E+00 alpha(00000066)=0.000000000000000E+00 beta (00000067)=0.128621512409166E+02 gamma(00000067)=0.128621512409166E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 67 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000067)=0.000000000000000E+00 beta (00000068)=0.133883494829368E+02 gamma(00000068)=0.133883494829368E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 68 z1= 1 -.171939230023382E-06 0.000000000000000E+00 z1= 2 0.111770566798777E-06 0.000000000000000E+00 z1= 3 -.363901346207935E-01 0.000000000000000E+00 alpha(00000068)=0.000000000000000E+00 beta (00000069)=0.128153644324818E+02 gamma(00000069)=0.128153644324818E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 69 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000069)=0.000000000000000E+00 beta (00000070)=0.133446925679119E+02 gamma(00000070)=0.133446925679119E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 70 z1= 1 0.167145257196598E-06 0.000000000000000E+00 z1= 2 -.115953043189039E-06 0.000000000000000E+00 z1= 3 0.345609269405845E-01 0.000000000000000E+00 alpha(00000070)=0.000000000000000E+00 beta (00000071)=0.128069908947247E+02 gamma(00000071)=0.128069908947247E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 71 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000071)=0.000000000000000E+00 beta (00000072)=0.134044170592001E+02 gamma(00000072)=0.134044170592001E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 72 z1= 1 -.161421382501199E-06 0.000000000000000E+00 z1= 2 0.114627281665365E-06 0.000000000000000E+00 z1= 3 -.326774730171455E-01 0.000000000000000E+00 alpha(00000072)=0.000000000000000E+00 beta (00000073)=0.128627070921725E+02 gamma(00000073)=0.128627070921725E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 73 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000073)=0.000000000000000E+00 beta (00000074)=0.133233015251622E+02 gamma(00000074)=0.133233015251622E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 74 z1= 1 0.161522530812280E-06 0.000000000000000E+00 z1= 2 -.113839031778615E-06 0.000000000000000E+00 z1= 3 0.312847904565644E-01 0.000000000000000E+00 alpha(00000074)=0.000000000000000E+00 beta (00000075)=0.127141550641070E+02 gamma(00000075)=0.127141550641070E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 75 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000075)=0.000000000000000E+00 beta (00000076)=0.133871084231584E+02 gamma(00000076)=0.133871084231584E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 76 z1= 1 -.159637918295888E-06 0.000000000000000E+00 z1= 2 0.109514634310409E-06 0.000000000000000E+00 z1= 3 -.294455562909207E-01 0.000000000000000E+00 alpha(00000076)=0.000000000000000E+00 beta (00000077)=0.127642048940118E+02 gamma(00000077)=0.127642048940118E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 77 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000077)=0.000000000000000E+00 beta (00000078)=0.133756594844790E+02 gamma(00000078)=0.133756594844790E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 78 z1= 1 0.161568014061609E-06 0.000000000000000E+00 z1= 2 -.102944876960345E-06 0.000000000000000E+00 z1= 3 0.278574044961943E-01 0.000000000000000E+00 alpha(00000078)=0.000000000000000E+00 beta (00000079)=0.128263638842413E+02 gamma(00000079)=0.128263638842413E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 79 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000079)=0.000000000000000E+00 beta (00000080)=0.133318285344546E+02 gamma(00000080)=0.133318285344546E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 80 z1= 1 -.164217384718930E-06 0.000000000000000E+00 z1= 2 0.100591462079403E-06 0.000000000000000E+00 z1= 3 -.266395049706488E-01 0.000000000000000E+00 alpha(00000080)=0.000000000000000E+00 beta (00000081)=0.127857473113699E+02 gamma(00000081)=0.127857473113699E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 81 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000081)=0.000000000000000E+00 beta (00000082)=0.133996447718333E+02 gamma(00000082)=0.133996447718333E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 82 z1= 1 0.163527200704823E-06 0.000000000000000E+00 z1= 2 -.101225353992863E-06 0.000000000000000E+00 z1= 3 0.252906906319655E-01 0.000000000000000E+00 alpha(00000082)=0.000000000000000E+00 beta (00000083)=0.128397176282553E+02 gamma(00000083)=0.128397176282553E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 83 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000083)=0.000000000000000E+00 beta (00000084)=0.133719719235862E+02 gamma(00000084)=0.133719719235862E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 84 z1= 1 -.168237970458052E-06 0.000000000000000E+00 z1= 2 0.105374778247851E-06 0.000000000000000E+00 z1= 3 -.241578226887974E-01 0.000000000000000E+00 alpha(00000084)=0.000000000000000E+00 beta (00000085)=0.128118028791986E+02 gamma(00000085)=0.128118028791986E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 85 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000085)=0.000000000000000E+00 beta (00000086)=0.133220368558979E+02 gamma(00000086)=0.133220368558979E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 86 z1= 1 0.173696184364511E-06 0.000000000000000E+00 z1= 2 -.115914400262724E-06 0.000000000000000E+00 z1= 3 0.231342997079415E-01 0.000000000000000E+00 alpha(00000086)=0.000000000000000E+00 beta (00000087)=0.127545617473317E+02 gamma(00000087)=0.127545617473317E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 87 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000087)=0.000000000000000E+00 beta (00000088)=0.133437915270970E+02 gamma(00000088)=0.133437915270970E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 88 z1= 1 -.175825717920082E-06 0.000000000000000E+00 z1= 2 0.125445776656544E-06 0.000000000000000E+00 z1= 3 -.220399303957018E-01 0.000000000000000E+00 alpha(00000088)=0.000000000000000E+00 beta (00000089)=0.128929327732329E+02 gamma(00000089)=0.128929327732329E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 89 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000089)=0.000000000000000E+00 beta (00000090)=0.133926940047842E+02 gamma(00000090)=0.133926940047842E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 90 z1= 1 0.178955280188704E-06 0.000000000000000E+00 z1= 2 -.133324497677515E-06 0.000000000000000E+00 z1= 3 0.211691489076850E-01 0.000000000000000E+00 alpha(00000090)=0.000000000000000E+00 beta (00000091)=0.126659771260063E+02 gamma(00000091)=0.126659771260063E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 91 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000091)=0.000000000000000E+00 beta (00000092)=0.133460215489823E+02 gamma(00000092)=0.133460215489823E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 92 z1= 1 -.180017196145781E-06 0.000000000000000E+00 z1= 2 0.140885317111432E-06 0.000000000000000E+00 z1= 3 -.200728401367680E-01 0.000000000000000E+00 alpha(00000092)=0.000000000000000E+00 beta (00000093)=0.127909474198665E+02 gamma(00000093)=0.127909474198665E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 93 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000093)=0.000000000000000E+00 beta (00000094)=0.133463370036378E+02 gamma(00000094)=0.133463370036378E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 94 z1= 1 0.185598085877684E-06 0.000000000000000E+00 z1= 2 -.145310176244450E-06 0.000000000000000E+00 z1= 3 0.192658714382339E-01 0.000000000000000E+00 alpha(00000094)=0.000000000000000E+00 beta (00000095)=0.127865904917952E+02 gamma(00000095)=0.127865904917952E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 95 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000095)=0.000000000000000E+00 beta (00000096)=0.133903067409472E+02 gamma(00000096)=0.133903067409472E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 96 z1= 1 -.188454410286233E-06 0.000000000000000E+00 z1= 2 0.141339691233473E-06 0.000000000000000E+00 z1= 3 -.184043119859318E-01 0.000000000000000E+00 alpha(00000096)=0.000000000000000E+00 beta (00000097)=0.127921106644359E+02 gamma(00000097)=0.127921106644359E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 97 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000097)=0.000000000000000E+00 beta (00000098)=0.134511209170548E+02 gamma(00000098)=0.134511209170548E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 98 z1= 1 0.193050601915131E-06 0.000000000000000E+00 z1= 2 -.131524011834496E-06 0.000000000000000E+00 z1= 3 0.174969378304614E-01 0.000000000000000E+00 alpha(00000098)=0.000000000000000E+00 beta (00000099)=0.130150108908867E+02 gamma(00000099)=0.130150108908867E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 99 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000099)=0.000000000000000E+00 beta (00000100)=0.136151551724768E+02 gamma(00000100)=0.136151551724768E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 100 z1= 1 -.196569490960733E-06 0.000000000000000E+00 z1= 2 0.123480974675762E-06 0.000000000000000E+00 z1= 3 -.167427851665358E-01 0.000000000000000E+00 alpha(00000100)=0.000000000000000E+00 beta (00000101)=0.127970451469151E+02 gamma(00000101)=0.127970451469151E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 101 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000101)=0.000000000000000E+00 beta (00000102)=0.132883962347640E+02 gamma(00000102)=0.132883962347640E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 102 z1= 1 0.198571941030859E-06 0.000000000000000E+00 z1= 2 -.119261527089457E-06 0.000000000000000E+00 z1= 3 0.161683836372862E-01 0.000000000000000E+00 alpha(00000102)=0.000000000000000E+00 beta (00000103)=0.128815591155137E+02 gamma(00000103)=0.128815591155137E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 103 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000103)=0.000000000000000E+00 beta (00000104)=0.134149799323614E+02 gamma(00000104)=0.134149799323614E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 104 z1= 1 -.199127860433601E-06 0.000000000000000E+00 z1= 2 0.117349870268335E-06 0.000000000000000E+00 z1= 3 -.156162470124623E-01 0.000000000000000E+00 alpha(00000104)=0.000000000000000E+00 beta (00000105)=0.128779014791790E+02 gamma(00000105)=0.128779014791790E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 105 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000105)=0.000000000000000E+00 beta (00000106)=0.132661758018605E+02 gamma(00000106)=0.132661758018605E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 106 z1= 1 0.198217793697221E-06 0.000000000000000E+00 z1= 2 -.119798246793457E-06 0.000000000000000E+00 z1= 3 0.152608842365239E-01 0.000000000000000E+00 alpha(00000106)=0.000000000000000E+00 beta (00000107)=0.126949037205540E+02 gamma(00000107)=0.126949037205540E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 107 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000107)=0.000000000000000E+00 beta (00000108)=0.133397977201443E+02 gamma(00000108)=0.133397977201443E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 108 z1= 1 -.194103216849583E-06 0.000000000000000E+00 z1= 2 0.117731079408219E-06 0.000000000000000E+00 z1= 3 -.145791600854246E-01 0.000000000000000E+00 alpha(00000108)=0.000000000000000E+00 beta (00000109)=0.128482327212091E+02 gamma(00000109)=0.128482327212091E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 109 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000109)=0.000000000000000E+00 beta (00000110)=0.133221249732650E+02 gamma(00000110)=0.133221249732650E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 110 z1= 1 0.194357580823260E-06 0.000000000000000E+00 z1= 2 -.120093220765138E-06 0.000000000000000E+00 z1= 3 0.141136418284599E-01 0.000000000000000E+00 alpha(00000110)=0.000000000000000E+00 beta (00000111)=0.126966174364142E+02 gamma(00000111)=0.126966174364142E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 111 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000111)=0.000000000000000E+00 beta (00000112)=0.135208590613030E+02 gamma(00000112)=0.135208590613030E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 112 z1= 1 -.188290795666225E-06 0.000000000000000E+00 z1= 2 0.115705173541110E-06 0.000000000000000E+00 z1= 3 -.133122842645561E-01 0.000000000000000E+00 alpha(00000112)=0.000000000000000E+00 beta (00000113)=0.129787363090662E+02 gamma(00000113)=0.129787363090662E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 113 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000113)=0.000000000000000E+00 beta (00000114)=0.134375148320549E+02 gamma(00000114)=0.134375148320549E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 114 z1= 1 0.190139262739100E-06 0.000000000000000E+00 z1= 2 -.117174226722675E-06 0.000000000000000E+00 z1= 3 0.128906142980088E-01 0.000000000000000E+00 alpha(00000114)=0.000000000000000E+00 beta (00000115)=0.127032864770732E+02 gamma(00000115)=0.127032864770732E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 115 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000115)=0.000000000000000E+00 beta (00000116)=0.135071537247181E+02 gamma(00000116)=0.135071537247181E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 116 z1= 1 -.189859971568072E-06 0.000000000000000E+00 z1= 2 0.120084708265242E-06 0.000000000000000E+00 z1= 3 -.122054791130487E-01 0.000000000000000E+00 alpha(00000116)=0.000000000000000E+00 beta (00000117)=0.127084745213771E+02 gamma(00000117)=0.127084745213771E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 117 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000117)=0.000000000000000E+00 beta (00000118)=0.132508095136839E+02 gamma(00000118)=0.132508095136839E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 118 z1= 1 0.191581607144903E-06 0.000000000000000E+00 z1= 2 -.123123161855862E-06 0.000000000000000E+00 z1= 3 0.118201677317263E-01 0.000000000000000E+00 alpha(00000118)=0.000000000000000E+00 beta (00000119)=0.127948196213349E+02 gamma(00000119)=0.127948196213349E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 119 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000119)=0.000000000000000E+00 beta (00000120)=0.133201073682607E+02 gamma(00000120)=0.133201073682607E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 120 z1= 1 -.191183821268562E-06 0.000000000000000E+00 z1= 2 0.123646908773984E-06 0.000000000000000E+00 z1= 3 -.114520932854157E-01 0.000000000000000E+00 alpha(00000120)=0.000000000000000E+00 beta (00000121)=0.125251297021628E+02 gamma(00000121)=0.125251297021628E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 121 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000121)=0.000000000000000E+00 beta (00000122)=0.131932745203476E+02 gamma(00000122)=0.131932745203476E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 122 z1= 1 0.185347567378238E-06 0.000000000000000E+00 z1= 2 -.120097435646024E-06 0.000000000000000E+00 z1= 3 0.109776651216943E-01 0.000000000000000E+00 alpha(00000122)=0.000000000000000E+00 beta (00000123)=0.127052681435011E+02 gamma(00000123)=0.127052681435011E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 123 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000123)=0.000000000000000E+00 beta (00000124)=0.133822011791843E+02 gamma(00000124)=0.133822011791843E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 124 z1= 1 -.179914568149077E-06 0.000000000000000E+00 z1= 2 0.118493529020346E-06 0.000000000000000E+00 z1= 3 -.104974489751836E-01 0.000000000000000E+00 alpha(00000124)=0.000000000000000E+00 beta (00000125)=0.126842714040156E+02 gamma(00000125)=0.126842714040156E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 125 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000125)=0.000000000000000E+00 beta (00000126)=0.133806511493505E+02 gamma(00000126)=0.133806511493505E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 126 z1= 1 0.179948620822464E-06 0.000000000000000E+00 z1= 2 -.120546890543369E-06 0.000000000000000E+00 z1= 3 0.100322759876657E-01 0.000000000000000E+00 alpha(00000126)=0.000000000000000E+00 beta (00000127)=0.128062265763581E+02 gamma(00000127)=0.128062265763581E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 127 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000127)=0.000000000000000E+00 beta (00000128)=0.132909494466209E+02 gamma(00000128)=0.132909494466209E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 128 z1= 1 -.187642837914319E-06 0.000000000000000E+00 z1= 2 0.124434770701267E-06 0.000000000000000E+00 z1= 3 -.972832489310506E-02 0.000000000000000E+00 alpha(00000128)=0.000000000000000E+00 beta (00000129)=0.127748179555013E+02 gamma(00000129)=0.127748179555013E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 129 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000129)=0.000000000000000E+00 beta (00000130)=0.132952918419124E+02 gamma(00000130)=0.132952918419124E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 130 z1= 1 0.195581513664405E-06 0.000000000000000E+00 z1= 2 -.127838272955276E-06 0.000000000000000E+00 z1= 3 0.940653044980759E-02 0.000000000000000E+00 alpha(00000130)=0.000000000000000E+00 beta (00000131)=0.127447078030274E+02 gamma(00000131)=0.127447078030274E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 131 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000131)=0.000000000000000E+00 beta (00000132)=0.131435710069964E+02 gamma(00000132)=0.131435710069964E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 132 z1= 1 -.205513091705383E-06 0.000000000000000E+00 z1= 2 0.130126511805901E-06 0.000000000000000E+00 z1= 3 -.917005978710429E-02 0.000000000000000E+00 alpha(00000132)=0.000000000000000E+00 beta (00000133)=0.127574462866586E+02 gamma(00000133)=0.127574462866586E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 133 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000133)=0.000000000000000E+00 beta (00000134)=0.134673006485662E+02 gamma(00000134)=0.134673006485662E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 134 z1= 1 0.204707538694910E-06 0.000000000000000E+00 z1= 2 -.127411892799809E-06 0.000000000000000E+00 z1= 3 0.868565255935684E-02 0.000000000000000E+00 alpha(00000134)=0.000000000000000E+00 beta (00000135)=0.127762518543190E+02 gamma(00000135)=0.127762518543190E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 135 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000135)=0.000000000000000E+00 beta (00000136)=0.134261518000896E+02 gamma(00000136)=0.134261518000896E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 136 z1= 1 -.204086496110797E-06 0.000000000000000E+00 z1= 2 0.121363210806220E-06 0.000000000000000E+00 z1= 3 -.829561779879034E-02 0.000000000000000E+00 alpha(00000136)=0.000000000000000E+00 beta (00000137)=0.129114131067484E+02 gamma(00000137)=0.129114131067484E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 137 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000137)=0.000000000000000E+00 beta (00000138)=0.133838994613118E+02 gamma(00000138)=0.133838994613118E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 138 z1= 1 0.202108394460544E-06 0.000000000000000E+00 z1= 2 -.112080156234543E-06 0.000000000000000E+00 z1= 3 0.808331849976019E-02 0.000000000000000E+00 alpha(00000138)=0.000000000000000E+00 beta (00000139)=0.129443553522419E+02 gamma(00000139)=0.129443553522419E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 139 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000139)=0.000000000000000E+00 beta (00000140)=0.135474780620436E+02 gamma(00000140)=0.135474780620436E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 140 z1= 1 -.194573781664561E-06 0.000000000000000E+00 z1= 2 0.101298992146706E-06 0.000000000000000E+00 z1= 3 -.781484890523640E-02 0.000000000000000E+00 alpha(00000140)=0.000000000000000E+00 beta (00000141)=0.127277879920875E+02 gamma(00000141)=0.127277879920875E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 141 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000141)=0.000000000000000E+00 beta (00000142)=0.134911103815614E+02 gamma(00000142)=0.134911103815614E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 142 z1= 1 0.181905367786740E-06 0.000000000000000E+00 z1= 2 -.962162705108252E-07 0.000000000000000E+00 z1= 3 0.746543800502850E-02 0.000000000000000E+00 alpha(00000142)=0.000000000000000E+00 beta (00000143)=0.127389218065796E+02 gamma(00000143)=0.127389218065796E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 143 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000143)=0.000000000000000E+00 beta (00000144)=0.134411291808047E+02 gamma(00000144)=0.134411291808047E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 144 z1= 1 -.173943244573824E-06 0.000000000000000E+00 z1= 2 0.937028267134410E-07 0.000000000000000E+00 z1= 3 -.714304705290933E-02 0.000000000000000E+00 alpha(00000144)=0.000000000000000E+00 beta (00000145)=0.129263312137132E+02 gamma(00000145)=0.129263312137132E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 145 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000145)=0.000000000000000E+00 beta (00000146)=0.133959104600217E+02 gamma(00000146)=0.133959104600217E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 146 z1= 1 0.173048615649063E-06 0.000000000000000E+00 z1= 2 -.945587305478473E-07 0.000000000000000E+00 z1= 3 0.694247778946082E-02 0.000000000000000E+00 alpha(00000146)=0.000000000000000E+00 beta (00000147)=0.128292383274937E+02 gamma(00000147)=0.128292383274937E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 147 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000147)=0.000000000000000E+00 beta (00000148)=0.136379000799285E+02 gamma(00000148)=0.136379000799285E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 148 z1= 1 -.170289294632378E-06 0.000000000000000E+00 z1= 2 0.953042871916130E-07 0.000000000000000E+00 z1= 3 -.656290448822854E-02 0.000000000000000E+00 alpha(00000148)=0.000000000000000E+00 beta (00000149)=0.127202850900892E+02 gamma(00000149)=0.127202850900892E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 149 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000149)=0.000000000000000E+00 beta (00000150)=0.135409248474752E+02 gamma(00000150)=0.135409248474752E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 150 z1= 1 0.163039018982074E-06 0.000000000000000E+00 z1= 2 -.960091186767817E-07 0.000000000000000E+00 z1= 3 0.617488593392207E-02 0.000000000000000E+00 alpha(00000150)=0.000000000000000E+00 beta (00000151)=0.126679672990993E+02 gamma(00000151)=0.126679672990993E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 151 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000151)=0.000000000000000E+00 beta (00000152)=0.134959031884114E+02 gamma(00000152)=0.134959031884114E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 152 z1= 1 -.155198870328463E-06 0.000000000000000E+00 z1= 2 0.951791022570374E-07 0.000000000000000E+00 z1= 3 -.579245867245388E-02 0.000000000000000E+00 alpha(00000152)=0.000000000000000E+00 beta (00000153)=0.125474371914202E+02 gamma(00000153)=0.125474371914202E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 153 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000153)=0.000000000000000E+00 beta (00000154)=0.132884241667002E+02 gamma(00000154)=0.132884241667002E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 154 z1= 1 0.149877741225366E-06 0.000000000000000E+00 z1= 2 -.943665167481202E-07 0.000000000000000E+00 z1= 3 0.544620684803302E-02 0.000000000000000E+00 alpha(00000154)=0.000000000000000E+00 beta (00000155)=0.128414498626476E+02 gamma(00000155)=0.128414498626476E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 155 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000155)=0.000000000000000E+00 beta (00000156)=0.133881973766190E+02 gamma(00000156)=0.133881973766190E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 156 z1= 1 -.144826828727979E-06 0.000000000000000E+00 z1= 2 0.896047792991149E-07 0.000000000000000E+00 z1= 3 -.518393418510534E-02 0.000000000000000E+00 alpha(00000156)=0.000000000000000E+00 beta (00000157)=0.128085738578133E+02 gamma(00000157)=0.128085738578133E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 157 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000157)=0.000000000000000E+00 beta (00000158)=0.135345784451435E+02 gamma(00000158)=0.135345784451435E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 158 z1= 1 0.136778081126737E-06 0.000000000000000E+00 z1= 2 -.842956403507094E-07 0.000000000000000E+00 z1= 3 0.481535141052775E-02 0.000000000000000E+00 alpha(00000158)=0.000000000000000E+00 beta (00000159)=0.127048636322934E+02 gamma(00000159)=0.127048636322934E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 159 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000159)=0.000000000000000E+00 beta (00000160)=0.132661194210346E+02 gamma(00000160)=0.132661194210346E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 160 z1= 1 -.134653020901184E-06 0.000000000000000E+00 z1= 2 0.878733697323573E-07 0.000000000000000E+00 z1= 3 -.451287266368120E-02 0.000000000000000E+00 alpha(00000160)=0.000000000000000E+00 beta (00000161)=0.125636012891411E+02 gamma(00000161)=0.125636012891411E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 161 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000161)=0.000000000000000E+00 beta (00000162)=0.133040220102759E+02 gamma(00000162)=0.133040220102759E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 162 z1= 1 0.135264047465707E-06 0.000000000000000E+00 z1= 2 -.911676225437034E-07 0.000000000000000E+00 z1= 3 0.422478788016315E-02 0.000000000000000E+00 alpha(00000162)=0.000000000000000E+00 beta (00000163)=0.127496111445353E+02 gamma(00000163)=0.127496111445353E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 163 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000163)=0.000000000000000E+00 beta (00000164)=0.131753996285055E+02 gamma(00000164)=0.131753996285055E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 164 z1= 1 -.132321336508473E-06 0.000000000000000E+00 z1= 2 0.889869356916762E-07 0.000000000000000E+00 z1= 3 -.410526575793220E-02 0.000000000000000E+00 alpha(00000164)=0.000000000000000E+00 beta (00000165)=0.126037216395622E+02 gamma(00000165)=0.126037216395622E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 165 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000165)=0.000000000000000E+00 beta (00000166)=0.134361143370248E+02 gamma(00000166)=0.134361143370248E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 166 z1= 1 0.125051116434046E-06 0.000000000000000E+00 z1= 2 -.770847584871410E-07 0.000000000000000E+00 z1= 3 0.389269266535866E-02 0.000000000000000E+00 alpha(00000166)=0.000000000000000E+00 beta (00000167)=0.127184991277893E+02 gamma(00000167)=0.127184991277893E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 167 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000167)=0.000000000000000E+00 beta (00000168)=0.134467298894481E+02 gamma(00000168)=0.134467298894481E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 168 z1= 1 -.123366172660321E-06 0.000000000000000E+00 z1= 2 0.663201530528678E-07 0.000000000000000E+00 z1= 3 -.378945252791138E-02 0.000000000000000E+00 alpha(00000168)=0.000000000000000E+00 beta (00000169)=0.127725685443734E+02 gamma(00000169)=0.127725685443734E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 169 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000169)=0.000000000000000E+00 beta (00000170)=0.132924810972545E+02 gamma(00000170)=0.132924810972545E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 170 z1= 1 0.123351985195099E-06 0.000000000000000E+00 z1= 2 -.651230871362614E-07 0.000000000000000E+00 z1= 3 0.374998083293552E-02 0.000000000000000E+00 alpha(00000170)=0.000000000000000E+00 beta (00000171)=0.127568410655392E+02 gamma(00000171)=0.127568410655392E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 171 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000171)=0.000000000000000E+00 beta (00000172)=0.133683994800247E+02 gamma(00000172)=0.133683994800247E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 172 z1= 1 -.121937969629980E-06 0.000000000000000E+00 z1= 2 0.637627847115769E-07 0.000000000000000E+00 z1= 3 -.370823771007426E-02 0.000000000000000E+00 alpha(00000172)=0.000000000000000E+00 beta (00000173)=0.127959850912328E+02 gamma(00000173)=0.127959850912328E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 173 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000173)=0.000000000000000E+00 beta (00000174)=0.134744090450484E+02 gamma(00000174)=0.134744090450484E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 174 z1= 1 0.123110696406453E-06 0.000000000000000E+00 z1= 2 -.597386368281954E-07 0.000000000000000E+00 z1= 3 0.356663771684316E-02 0.000000000000000E+00 alpha(00000174)=0.000000000000000E+00 beta (00000175)=0.128361285384202E+02 gamma(00000175)=0.128361285384202E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 175 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000175)=0.000000000000000E+00 beta (00000176)=0.133958461477995E+02 gamma(00000176)=0.133958461477995E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 176 z1= 1 -.122890921252865E-06 0.000000000000000E+00 z1= 2 0.625200242731550E-07 0.000000000000000E+00 z1= 3 -.335056686820362E-02 0.000000000000000E+00 alpha(00000176)=0.000000000000000E+00 beta (00000177)=0.127371042581367E+02 gamma(00000177)=0.127371042581367E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 177 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000177)=0.000000000000000E+00 beta (00000178)=0.133612402387654E+02 gamma(00000178)=0.133612402387654E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 178 z1= 1 0.121335403734254E-06 0.000000000000000E+00 z1= 2 -.643047551629776E-07 0.000000000000000E+00 z1= 3 0.311756522330512E-02 0.000000000000000E+00 alpha(00000178)=0.000000000000000E+00 beta (00000179)=0.126228391775088E+02 gamma(00000179)=0.126228391775088E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 179 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000179)=0.000000000000000E+00 beta (00000180)=0.134190343182693E+02 gamma(00000180)=0.134190343182693E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 180 z1= 1 -.114608661094568E-06 0.000000000000000E+00 z1= 2 0.634888969611798E-07 0.000000000000000E+00 z1= 3 -.280069196416582E-02 0.000000000000000E+00 alpha(00000180)=0.000000000000000E+00 beta (00000181)=0.127642869203728E+02 gamma(00000181)=0.127642869203728E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 181 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000181)=0.000000000000000E+00 beta (00000182)=0.134410607112103E+02 gamma(00000182)=0.134410607112103E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 182 z1= 1 0.109266052597144E-06 0.000000000000000E+00 z1= 2 -.630399514290898E-07 0.000000000000000E+00 z1= 3 0.252340124488306E-02 0.000000000000000E+00 alpha(00000182)=0.000000000000000E+00 beta (00000183)=0.128179278500614E+02 gamma(00000183)=0.128179278500614E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 183 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000183)=0.000000000000000E+00 beta (00000184)=0.135091022747419E+02 gamma(00000184)=0.135091022747419E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 184 z1= 1 -.105845015357627E-06 0.000000000000000E+00 z1= 2 0.654325577267997E-07 0.000000000000000E+00 z1= 3 -.228736912134155E-02 0.000000000000000E+00 alpha(00000184)=0.000000000000000E+00 beta (00000185)=0.129153918879666E+02 gamma(00000185)=0.129153918879666E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 185 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000185)=0.000000000000000E+00 beta (00000186)=0.133112580307265E+02 gamma(00000186)=0.133112580307265E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 186 z1= 1 0.108932207397720E-06 0.000000000000000E+00 z1= 2 -.696395129044130E-07 0.000000000000000E+00 z1= 3 0.207940550921447E-02 0.000000000000000E+00 alpha(00000186)=0.000000000000000E+00 beta (00000187)=0.127265506543744E+02 gamma(00000187)=0.127265506543744E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 187 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000187)=0.000000000000000E+00 beta (00000188)=0.134540131811004E+02 gamma(00000188)=0.134540131811004E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 188 z1= 1 -.109037234775899E-06 0.000000000000000E+00 z1= 2 0.663813283060719E-07 0.000000000000000E+00 z1= 3 -.185387417137135E-02 0.000000000000000E+00 alpha(00000188)=0.000000000000000E+00 beta (00000189)=0.129511689057991E+02 gamma(00000189)=0.129511689057991E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 189 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000189)=0.000000000000000E+00 beta (00000190)=0.137069660505945E+02 gamma(00000190)=0.137069660505945E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 190 z1= 1 0.108892997531735E-06 0.000000000000000E+00 z1= 2 -.593815433464579E-07 0.000000000000000E+00 z1= 3 0.163077622667265E-02 0.000000000000000E+00 alpha(00000190)=0.000000000000000E+00 beta (00000191)=0.128653302395823E+02 gamma(00000191)=0.128653302395823E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 191 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000191)=0.000000000000000E+00 beta (00000192)=0.134375828595412E+02 gamma(00000192)=0.134375828595412E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 192 z1= 1 -.106433660872825E-06 0.000000000000000E+00 z1= 2 0.507735941894137E-07 0.000000000000000E+00 z1= 3 -.143511663396030E-02 0.000000000000000E+00 alpha(00000192)=0.000000000000000E+00 beta (00000193)=0.127839853962210E+02 gamma(00000193)=0.127839853962210E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 193 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000193)=0.000000000000000E+00 beta (00000194)=0.131984570917387E+02 gamma(00000194)=0.131984570917387E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 194 z1= 1 0.104662608482200E-06 0.000000000000000E+00 z1= 2 -.426065835303571E-07 0.000000000000000E+00 z1= 3 0.131191173036188E-02 0.000000000000000E+00 alpha(00000194)=0.000000000000000E+00 beta (00000195)=0.126837499545938E+02 gamma(00000195)=0.126837499545938E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 195 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000195)=0.000000000000000E+00 beta (00000196)=0.133145755626384E+02 gamma(00000196)=0.133145755626384E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 196 z1= 1 -.100253665728453E-06 0.000000000000000E+00 z1= 2 0.444592808620143E-07 0.000000000000000E+00 z1= 3 -.121256522975955E-02 0.000000000000000E+00 alpha(00000196)=0.000000000000000E+00 beta (00000197)=0.126075491643804E+02 gamma(00000197)=0.126075491643804E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 197 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000197)=0.000000000000000E+00 beta (00000198)=0.136346682186363E+02 gamma(00000198)=0.136346682186363E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 198 z1= 1 0.942651098448464E-07 0.000000000000000E+00 z1= 2 -.472556227677529E-07 0.000000000000000E+00 z1= 3 0.114047207006596E-02 0.000000000000000E+00 alpha(00000198)=0.000000000000000E+00 beta (00000199)=0.126706457756123E+02 gamma(00000199)=0.126706457756123E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 199 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000199)=0.000000000000000E+00 beta (00000200)=0.134979843770719E+02 gamma(00000200)=0.134979843770719E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 200 z1= 1 -.912768762293374E-07 0.000000000000000E+00 z1= 2 0.477731609747315E-07 0.000000000000000E+00 z1= 3 -.113631373952937E-02 0.000000000000000E+00 alpha(00000200)=0.000000000000000E+00 beta (00000201)=0.126144786516395E+02 gamma(00000201)=0.126144786516395E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 201 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000201)=0.000000000000000E+00 beta (00000202)=0.133827098847655E+02 gamma(00000202)=0.133827098847655E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 202 z1= 1 0.905367433668959E-07 0.000000000000000E+00 z1= 2 -.452167873778208E-07 0.000000000000000E+00 z1= 3 0.113726021181960E-02 0.000000000000000E+00 alpha(00000202)=0.000000000000000E+00 beta (00000203)=0.127737667132230E+02 gamma(00000203)=0.127737667132230E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 203 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000203)=0.000000000000000E+00 beta (00000204)=0.135577205948439E+02 gamma(00000204)=0.135577205948439E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 204 z1= 1 -.875049493226040E-07 0.000000000000000E+00 z1= 2 0.414231566515867E-07 0.000000000000000E+00 z1= 3 -.111814478053696E-02 0.000000000000000E+00 alpha(00000204)=0.000000000000000E+00 beta (00000205)=0.128451021494677E+02 gamma(00000205)=0.128451021494677E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 205 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000205)=0.000000000000000E+00 beta (00000206)=0.134794013819225E+02 gamma(00000206)=0.134794013819225E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 206 z1= 1 0.852923013551412E-07 0.000000000000000E+00 z1= 2 -.383770035493119E-07 0.000000000000000E+00 z1= 3 0.117277623441991E-02 0.000000000000000E+00 alpha(00000206)=0.000000000000000E+00 beta (00000207)=0.127619768799232E+02 gamma(00000207)=0.127619768799232E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 207 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000207)=0.000000000000000E+00 beta (00000208)=0.133843608945064E+02 gamma(00000208)=0.133843608945064E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 208 z1= 1 -.848830473473968E-07 0.000000000000000E+00 z1= 2 0.350355034402575E-07 0.000000000000000E+00 z1= 3 -.124902314365290E-02 0.000000000000000E+00 alpha(00000208)=0.000000000000000E+00 beta (00000209)=0.126285789779613E+02 gamma(00000209)=0.126285789779613E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 209 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000209)=0.000000000000000E+00 beta (00000210)=0.135245908910645E+02 gamma(00000210)=0.135245908910645E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 210 z1= 1 0.843229182221315E-07 0.000000000000000E+00 z1= 2 -.368504167255626E-07 0.000000000000000E+00 z1= 3 0.133100660287162E-02 0.000000000000000E+00 alpha(00000210)=0.000000000000000E+00 beta (00000211)=0.126502762951041E+02 gamma(00000211)=0.126502762951041E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 211 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000211)=0.000000000000000E+00 beta (00000212)=0.135865801768045E+02 gamma(00000212)=0.135865801768045E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 212 z1= 1 -.873989518031942E-07 0.000000000000000E+00 z1= 2 0.424602108119068E-07 0.000000000000000E+00 z1= 3 -.133866461217578E-02 0.000000000000000E+00 alpha(00000212)=0.000000000000000E+00 beta (00000213)=0.126861049958598E+02 gamma(00000213)=0.126861049958598E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 213 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000213)=0.000000000000000E+00 beta (00000214)=0.134728739299004E+02 gamma(00000214)=0.134728739299004E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 214 z1= 1 0.927209609629526E-07 0.000000000000000E+00 z1= 2 -.461577201583507E-07 0.000000000000000E+00 z1= 3 0.123946581426077E-02 0.000000000000000E+00 alpha(00000214)=0.000000000000000E+00 beta (00000215)=0.125569291296839E+02 gamma(00000215)=0.125569291296839E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 215 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000215)=0.000000000000000E+00 beta (00000216)=0.132491064493151E+02 gamma(00000216)=0.132491064493151E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 216 z1= 1 -.971956324411372E-07 0.000000000000000E+00 z1= 2 0.425228112390139E-07 0.000000000000000E+00 z1= 3 -.111657114809390E-02 0.000000000000000E+00 alpha(00000216)=0.000000000000000E+00 beta (00000217)=0.124622988808800E+02 gamma(00000217)=0.124622988808800E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 217 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000217)=0.000000000000000E+00 beta (00000218)=0.136511868475233E+02 gamma(00000218)=0.136511868475233E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 218 z1= 1 0.981268037688991E-07 0.000000000000000E+00 z1= 2 -.348830992575591E-07 0.000000000000000E+00 z1= 3 0.924462539644040E-03 0.000000000000000E+00 alpha(00000218)=0.000000000000000E+00 beta (00000219)=0.127279555053008E+02 gamma(00000219)=0.127279555053008E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 219 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000219)=0.000000000000000E+00 beta (00000220)=0.134284306632115E+02 gamma(00000220)=0.134284306632115E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 220 z1= 1 -.983459970862587E-07 0.000000000000000E+00 z1= 2 0.326569174786414E-07 0.000000000000000E+00 z1= 3 -.774288250822419E-03 0.000000000000000E+00 alpha(00000220)=0.000000000000000E+00 beta (00000221)=0.127708034645656E+02 gamma(00000221)=0.127708034645656E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 221 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000221)=0.000000000000000E+00 beta (00000222)=0.132931670191610E+02 gamma(00000222)=0.132931670191610E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 222 z1= 1 0.999227442307835E-07 0.000000000000000E+00 z1= 2 -.324096041941658E-07 0.000000000000000E+00 z1= 3 0.618122812859492E-03 0.000000000000000E+00 alpha(00000222)=0.000000000000000E+00 beta (00000223)=0.128285612590235E+02 gamma(00000223)=0.128285612590235E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 223 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000223)=0.000000000000000E+00 beta (00000224)=0.132059502441003E+02 gamma(00000224)=0.132059502441003E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 224 z1= 1 -.102749665018519E-06 0.000000000000000E+00 z1= 2 0.339531893739256E-07 0.000000000000000E+00 z1= 3 -.427802132400936E-03 0.000000000000000E+00 alpha(00000224)=0.000000000000000E+00 beta (00000225)=0.129768278830731E+02 gamma(00000225)=0.129768278830731E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 225 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000225)=0.000000000000000E+00 beta (00000226)=0.133547437589162E+02 gamma(00000226)=0.133547437589162E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 226 z1= 1 0.105064361345707E-06 0.000000000000000E+00 z1= 2 -.342774930793977E-07 0.000000000000000E+00 z1= 3 0.233665144442405E-03 0.000000000000000E+00 alpha(00000226)=0.000000000000000E+00 beta (00000227)=0.128221378136514E+02 gamma(00000227)=0.128221378136514E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 227 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000227)=0.000000000000000E+00 beta (00000228)=0.135114450877762E+02 gamma(00000228)=0.135114450877762E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 228 z1= 1 -.106814614703101E-06 0.000000000000000E+00 z1= 2 0.264313778139793E-07 0.000000000000000E+00 z1= 3 -.742611392332655E-04 0.000000000000000E+00 alpha(00000228)=0.000000000000000E+00 beta (00000229)=0.127023359837620E+02 gamma(00000229)=0.127023359837620E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 229 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000229)=0.000000000000000E+00 beta (00000230)=0.134493722967890E+02 gamma(00000230)=0.134493722967890E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 230 z1= 1 0.105521790043925E-06 0.000000000000000E+00 z1= 2 -.160420984468882E-07 0.000000000000000E+00 z1= 3 -.479529164884350E-04 0.000000000000000E+00 alpha(00000230)=0.000000000000000E+00 beta (00000231)=0.129121582341986E+02 gamma(00000231)=0.129121582341986E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 231 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000231)=0.000000000000000E+00 beta (00000232)=0.137270848950680E+02 gamma(00000232)=0.137270848950680E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 232 z1= 1 -.104097100330717E-06 0.000000000000000E+00 z1= 2 0.937139391988303E-08 0.000000000000000E+00 z1= 3 0.115641190590636E-03 0.000000000000000E+00 alpha(00000232)=0.000000000000000E+00 beta (00000233)=0.127783713151142E+02 gamma(00000233)=0.127783713151142E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 233 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000233)=0.000000000000000E+00 beta (00000234)=0.133505837100419E+02 gamma(00000234)=0.133505837100419E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 234 z1= 1 0.109367980964800E-06 0.000000000000000E+00 z1= 2 -.144050205738049E-07 0.000000000000000E+00 z1= 3 -.182067098134212E-03 0.000000000000000E+00 alpha(00000234)=0.000000000000000E+00 beta (00000235)=0.125912997191666E+02 gamma(00000235)=0.125912997191666E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 235 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000235)=0.000000000000000E+00 beta (00000236)=0.133931010946337E+02 gamma(00000236)=0.133931010946337E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 236 z1= 1 -.114198879961605E-06 0.000000000000000E+00 z1= 2 0.261013625270715E-07 0.000000000000000E+00 z1= 3 0.215505814911907E-03 0.000000000000000E+00 alpha(00000236)=0.000000000000000E+00 beta (00000237)=0.128916034385239E+02 gamma(00000237)=0.128916034385239E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 237 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000237)=0.000000000000000E+00 beta (00000238)=0.135199834860097E+02 gamma(00000238)=0.135199834860097E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 238 z1= 1 0.120245483626854E-06 0.000000000000000E+00 z1= 2 -.328234267670002E-07 0.000000000000000E+00 z1= 3 -.249002512673825E-03 0.000000000000000E+00 alpha(00000238)=0.000000000000000E+00 beta (00000239)=0.127638000653660E+02 gamma(00000239)=0.127638000653660E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 239 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000239)=0.000000000000000E+00 beta (00000240)=0.133599255688922E+02 gamma(00000240)=0.133599255688922E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 240 z1= 1 -.123566617901130E-06 0.000000000000000E+00 z1= 2 0.347817259178235E-07 0.000000000000000E+00 z1= 3 0.256595058468878E-03 0.000000000000000E+00 alpha(00000240)=0.000000000000000E+00 beta (00000241)=0.127491480720262E+02 gamma(00000241)=0.127491480720262E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 241 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000241)=0.000000000000000E+00 beta (00000242)=0.134030855642902E+02 gamma(00000242)=0.134030855642902E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 242 z1= 1 0.120573788036553E-06 0.000000000000000E+00 z1= 2 -.313383597421888E-07 0.000000000000000E+00 z1= 3 -.218612179428796E-03 0.000000000000000E+00 alpha(00000242)=0.000000000000000E+00 beta (00000243)=0.128891582239729E+02 gamma(00000243)=0.128891582239729E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 243 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000243)=0.000000000000000E+00 beta (00000244)=0.135143963138812E+02 gamma(00000244)=0.135143963138812E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 244 z1= 1 -.118711608245543E-06 0.000000000000000E+00 z1= 2 0.276862506305860E-07 0.000000000000000E+00 z1= 3 0.177569372324491E-03 0.000000000000000E+00 alpha(00000244)=0.000000000000000E+00 beta (00000245)=0.125468367908837E+02 gamma(00000245)=0.125468367908837E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 245 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000245)=0.000000000000000E+00 beta (00000246)=0.130512642635966E+02 gamma(00000246)=0.130512642635966E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 246 z1= 1 0.121602022964962E-06 0.000000000000000E+00 z1= 2 -.271882379879055E-07 0.000000000000000E+00 z1= 3 -.695071549201803E-04 0.000000000000000E+00 alpha(00000246)=0.000000000000000E+00 beta (00000247)=0.125670617375107E+02 gamma(00000247)=0.125670617375107E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 247 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000247)=0.000000000000000E+00 beta (00000248)=0.133323984566923E+02 gamma(00000248)=0.133323984566923E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 248 z1= 1 -.125230015334595E-06 0.000000000000000E+00 z1= 2 0.271717566672027E-07 0.000000000000000E+00 z1= 3 -.259192495117699E-04 0.000000000000000E+00 alpha(00000248)=0.000000000000000E+00 beta (00000249)=0.127879972582805E+02 gamma(00000249)=0.127879972582805E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 249 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000249)=0.000000000000000E+00 beta (00000250)=0.134569258864109E+02 gamma(00000250)=0.134569258864109E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 250 z1= 1 0.132018071356821E-06 0.000000000000000E+00 z1= 2 -.275805740902594E-07 0.000000000000000E+00 z1= 3 0.128058766148580E-03 0.000000000000000E+00 alpha(00000250)=0.000000000000000E+00 beta (00000251)=0.125505307777228E+02 gamma(00000251)=0.125505307777228E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 251 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000251)=0.000000000000000E+00 beta (00000252)=0.132839984278634E+02 gamma(00000252)=0.132839984278634E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 252 z1= 1 -.143052251109664E-06 0.000000000000000E+00 z1= 2 0.372727447918528E-07 0.000000000000000E+00 z1= 3 -.178472464578825E-03 0.000000000000000E+00 alpha(00000252)=0.000000000000000E+00 beta (00000253)=0.129335061397071E+02 gamma(00000253)=0.129335061397071E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 253 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000253)=0.000000000000000E+00 beta (00000254)=0.135153279447823E+02 gamma(00000254)=0.135153279447823E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 254 z1= 1 0.150464220461310E-06 0.000000000000000E+00 z1= 2 -.475660504014653E-07 0.000000000000000E+00 z1= 3 0.150113870835671E-03 0.000000000000000E+00 alpha(00000254)=0.000000000000000E+00 beta (00000255)=0.128017617153721E+02 gamma(00000255)=0.128017617153721E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 255 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000255)=0.000000000000000E+00 beta (00000256)=0.136717460357793E+02 gamma(00000256)=0.136717460357793E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 256 z1= 1 -.151920936019819E-06 0.000000000000000E+00 z1= 2 0.565916551579051E-07 0.000000000000000E+00 z1= 3 -.136176925428573E-03 0.000000000000000E+00 alpha(00000256)=0.000000000000000E+00 beta (00000257)=0.128304020272459E+02 gamma(00000257)=0.128304020272459E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 257 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000257)=0.000000000000000E+00 beta (00000258)=0.134220712536871E+02 gamma(00000258)=0.134220712536871E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 258 z1= 1 0.150624303936649E-06 0.000000000000000E+00 z1= 2 -.609362420062813E-07 0.000000000000000E+00 z1= 3 0.137406084396904E-03 0.000000000000000E+00 alpha(00000258)=0.000000000000000E+00 beta (00000259)=0.130323950031108E+02 gamma(00000259)=0.130323950031108E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 259 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000259)=0.000000000000000E+00 beta (00000260)=0.135344428686682E+02 gamma(00000260)=0.135344428686682E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 260 z1= 1 -.147308848142248E-06 0.000000000000000E+00 z1= 2 0.545320091913765E-07 0.000000000000000E+00 z1= 3 -.919376933632907E-04 0.000000000000000E+00 alpha(00000260)=0.000000000000000E+00 beta (00000261)=0.127717831411902E+02 gamma(00000261)=0.127717831411902E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 261 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000261)=0.000000000000000E+00 beta (00000262)=0.133224133227432E+02 gamma(00000262)=0.133224133227432E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 262 z1= 1 0.145626524619219E-06 0.000000000000000E+00 z1= 2 -.436576429620325E-07 0.000000000000000E+00 z1= 3 0.470217141600249E-04 0.000000000000000E+00 alpha(00000262)=0.000000000000000E+00 beta (00000263)=0.126369565915435E+02 gamma(00000263)=0.126369565915435E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 263 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000263)=0.000000000000000E+00 beta (00000264)=0.132589099020120E+02 gamma(00000264)=0.132589099020120E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 264 z1= 1 -.149922574946141E-06 0.000000000000000E+00 z1= 2 0.363589418660008E-07 0.000000000000000E+00 z1= 3 -.373713738322911E-05 0.000000000000000E+00 alpha(00000264)=0.000000000000000E+00 beta (00000265)=0.127325985443160E+02 gamma(00000265)=0.127325985443160E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 265 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000265)=0.000000000000000E+00 beta (00000266)=0.134482047400527E+02 gamma(00000266)=0.134482047400527E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 266 z1= 1 0.154690561113377E-06 0.000000000000000E+00 z1= 2 -.333928661650602E-07 0.000000000000000E+00 z1= 3 0.575833802621186E-05 0.000000000000000E+00 alpha(00000266)=0.000000000000000E+00 beta (00000267)=0.127991456760382E+02 gamma(00000267)=0.127991456760382E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 267 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000267)=0.000000000000000E+00 beta (00000268)=0.133513085506130E+02 gamma(00000268)=0.133513085506130E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 268 z1= 1 -.159294240419935E-06 0.000000000000000E+00 z1= 2 0.334596533851017E-07 0.000000000000000E+00 z1= 3 -.561103468861368E-04 0.000000000000000E+00 alpha(00000268)=0.000000000000000E+00 beta (00000269)=0.126158983622935E+02 gamma(00000269)=0.126158983622935E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 269 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000269)=0.000000000000000E+00 beta (00000270)=0.135205354990998E+02 gamma(00000270)=0.135205354990998E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 270 z1= 1 0.164742811039648E-06 0.000000000000000E+00 z1= 2 -.373203749949656E-07 0.000000000000000E+00 z1= 3 0.126570556541724E-03 0.000000000000000E+00 alpha(00000270)=0.000000000000000E+00 beta (00000271)=0.130326462556338E+02 gamma(00000271)=0.130326462556338E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 271 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000271)=0.000000000000000E+00 beta (00000272)=0.132961228452800E+02 gamma(00000272)=0.132961228452800E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 272 z1= 1 -.185459331499186E-06 0.000000000000000E+00 z1= 2 0.432410374583028E-07 0.000000000000000E+00 z1= 3 -.191080675449477E-03 0.000000000000000E+00 alpha(00000272)=0.000000000000000E+00 beta (00000273)=0.127265895132693E+02 gamma(00000273)=0.127265895132693E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 273 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000273)=0.000000000000000E+00 beta (00000274)=0.134988994369480E+02 gamma(00000274)=0.134988994369480E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 274 z1= 1 0.192414506606381E-06 0.000000000000000E+00 z1= 2 -.436288013508043E-07 0.000000000000000E+00 z1= 3 0.169616432381530E-03 0.000000000000000E+00 alpha(00000274)=0.000000000000000E+00 beta (00000275)=0.128619369787183E+02 gamma(00000275)=0.128619369787183E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 275 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000275)=0.000000000000000E+00 beta (00000276)=0.137442800990825E+02 gamma(00000276)=0.137442800990825E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 276 z1= 1 -.193486466446230E-06 0.000000000000000E+00 z1= 2 0.419826961113286E-07 0.000000000000000E+00 z1= 3 -.141998309676413E-03 0.000000000000000E+00 alpha(00000276)=0.000000000000000E+00 beta (00000277)=0.127469271930267E+02 gamma(00000277)=0.127469271930267E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 277 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000277)=0.000000000000000E+00 beta (00000278)=0.131865650439469E+02 gamma(00000278)=0.131865650439469E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 278 z1= 1 0.200290633431389E-06 0.000000000000000E+00 z1= 2 -.403645966965630E-07 0.000000000000000E+00 z1= 3 0.108768461265919E-03 0.000000000000000E+00 alpha(00000278)=0.000000000000000E+00 beta (00000279)=0.125348597433099E+02 gamma(00000279)=0.125348597433099E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 279 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000279)=0.000000000000000E+00 beta (00000280)=0.133611704540449E+02 gamma(00000280)=0.133611704540449E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 280 z1= 1 -.196058965273469E-06 0.000000000000000E+00 z1= 2 0.418849684229194E-07 0.000000000000000E+00 z1= 3 -.751839424584298E-04 0.000000000000000E+00 alpha(00000280)=0.000000000000000E+00 beta (00000281)=0.128735883456207E+02 gamma(00000281)=0.128735883456207E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 281 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000281)=0.000000000000000E+00 beta (00000282)=0.132965513893925E+02 gamma(00000282)=0.132965513893925E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 282 z1= 1 0.195194046501883E-06 0.000000000000000E+00 z1= 2 -.416267850030178E-07 0.000000000000000E+00 z1= 3 0.268073827704041E-04 0.000000000000000E+00 alpha(00000282)=0.000000000000000E+00 beta (00000283)=0.125943199037055E+02 gamma(00000283)=0.125943199037055E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 283 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000283)=0.000000000000000E+00 beta (00000284)=0.132145350184674E+02 gamma(00000284)=0.132145350184674E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 284 z1= 1 -.187639218118666E-06 0.000000000000000E+00 z1= 2 0.442016520031891E-07 0.000000000000000E+00 z1= 3 0.591835750822032E-04 0.000000000000000E+00 alpha(00000284)=0.000000000000000E+00 beta (00000285)=0.126626664212446E+02 gamma(00000285)=0.126626664212446E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 285 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000285)=0.000000000000000E+00 beta (00000286)=0.134123830932432E+02 gamma(00000286)=0.134123830932432E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 286 z1= 1 0.184273228694847E-06 0.000000000000000E+00 z1= 2 -.504990041185448E-07 0.000000000000000E+00 z1= 3 -.191815302620703E-03 0.000000000000000E+00 alpha(00000286)=0.000000000000000E+00 beta (00000287)=0.126243408976183E+02 gamma(00000287)=0.126243408976183E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 287 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000287)=0.000000000000000E+00 beta (00000288)=0.130877011244592E+02 gamma(00000288)=0.130877011244592E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 288 z1= 1 -.190596684576704E-06 0.000000000000000E+00 z1= 2 0.526846706564387E-07 0.000000000000000E+00 z1= 3 0.350563349246751E-03 0.000000000000000E+00 alpha(00000288)=0.000000000000000E+00 beta (00000289)=0.127644151084029E+02 gamma(00000289)=0.127644151084029E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 289 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000289)=0.000000000000000E+00 beta (00000290)=0.134269534886090E+02 gamma(00000290)=0.134269534886090E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 290 z1= 1 0.197066642494622E-06 0.000000000000000E+00 z1= 2 -.522566002779780E-07 0.000000000000000E+00 z1= 3 -.501958224276144E-03 0.000000000000000E+00 alpha(00000290)=0.000000000000000E+00 beta (00000291)=0.127608149270605E+02 gamma(00000291)=0.127608149270605E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 291 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000291)=0.000000000000000E+00 beta (00000292)=0.131981570303342E+02 gamma(00000292)=0.131981570303342E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 292 z1= 1 -.204762034387916E-06 0.000000000000000E+00 z1= 2 0.476745750030969E-07 0.000000000000000E+00 z1= 3 0.625933042205833E-03 0.000000000000000E+00 alpha(00000292)=0.000000000000000E+00 beta (00000293)=0.126409940678408E+02 gamma(00000293)=0.126409940678408E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 293 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000293)=0.000000000000000E+00 beta (00000294)=0.135270564394367E+02 gamma(00000294)=0.135270564394367E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 294 z1= 1 0.201340484212947E-06 0.000000000000000E+00 z1= 2 -.444749892072427E-07 0.000000000000000E+00 z1= 3 -.726211404709553E-03 0.000000000000000E+00 alpha(00000294)=0.000000000000000E+00 beta (00000295)=0.129785216477365E+02 gamma(00000295)=0.129785216477365E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 295 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000295)=0.000000000000000E+00 beta (00000296)=0.135626794438680E+02 gamma(00000296)=0.135626794438680E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 296 z1= 1 -.196874431575240E-06 0.000000000000000E+00 z1= 2 0.394085927750968E-07 0.000000000000000E+00 z1= 3 0.768654966120697E-03 0.000000000000000E+00 alpha(00000296)=0.000000000000000E+00 beta (00000297)=0.127909956826747E+02 gamma(00000297)=0.127909956826747E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 297 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000297)=0.000000000000000E+00 beta (00000298)=0.133438361463309E+02 gamma(00000298)=0.133438361463309E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 298 z1= 1 0.192853601482237E-06 0.000000000000000E+00 z1= 2 -.396890997836412E-07 0.000000000000000E+00 z1= 3 -.707224631922226E-03 0.000000000000000E+00 alpha(00000298)=0.000000000000000E+00 beta (00000299)=0.130103407814547E+02 gamma(00000299)=0.130103407814547E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 299 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000299)=0.000000000000000E+00 beta (00000300)=0.136894539126656E+02 gamma(00000300)=0.136894539126656E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 300 z1= 1 -.186332479859292E-06 0.000000000000000E+00 z1= 2 0.416301304870638E-07 0.000000000000000E+00 z1= 3 0.684049192233499E-03 0.000000000000000E+00 alpha(00000300)=0.000000000000000E+00 beta (00000301)=0.127328190367471E+02 gamma(00000301)=0.127328190367471E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 301 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000301)=0.000000000000000E+00 beta (00000302)=0.132016648620965E+02 gamma(00000302)=0.132016648620965E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 302 z1= 1 0.193071187778765E-06 0.000000000000000E+00 z1= 2 -.391991057506491E-07 0.000000000000000E+00 z1= 3 -.646443489247172E-03 0.000000000000000E+00 alpha(00000302)=0.000000000000000E+00 beta (00000303)=0.127866561054555E+02 gamma(00000303)=0.127866561054555E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 303 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000303)=0.000000000000000E+00 beta (00000304)=0.135650719597403E+02 gamma(00000304)=0.135650719597403E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 304 z1= 1 -.200407702543389E-06 0.000000000000000E+00 z1= 2 0.377217128445838E-07 0.000000000000000E+00 z1= 3 0.550092367730127E-03 0.000000000000000E+00 alpha(00000304)=0.000000000000000E+00 beta (00000305)=0.128308359588909E+02 gamma(00000305)=0.128308359588909E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 305 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000305)=0.000000000000000E+00 beta (00000306)=0.134497836035884E+02 gamma(00000306)=0.134497836035884E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 306 z1= 1 0.210864848580175E-06 0.000000000000000E+00 z1= 2 -.376804782360827E-07 0.000000000000000E+00 z1= 3 -.425160119269811E-03 0.000000000000000E+00 alpha(00000306)=0.000000000000000E+00 beta (00000307)=0.127985135269329E+02 gamma(00000307)=0.127985135269329E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 307 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000307)=0.000000000000000E+00 beta (00000308)=0.135697978161114E+02 gamma(00000308)=0.135697978161114E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 308 z1= 1 -.210714773840647E-06 0.000000000000000E+00 z1= 2 0.377008741039657E-07 0.000000000000000E+00 z1= 3 0.238230458933807E-03 0.000000000000000E+00 alpha(00000308)=0.000000000000000E+00 beta (00000309)=0.127887276328970E+02 gamma(00000309)=0.127887276328970E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 309 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000309)=0.000000000000000E+00 beta (00000310)=0.133080250237660E+02 gamma(00000310)=0.133080250237660E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 310 z1= 1 0.212918290086635E-06 0.000000000000000E+00 z1= 2 -.384488806719468E-07 0.000000000000000E+00 z1= 3 -.690347336590137E-04 0.000000000000000E+00 alpha(00000310)=0.000000000000000E+00 beta (00000311)=0.127284898198900E+02 gamma(00000311)=0.127284898198900E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 311 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000311)=0.000000000000000E+00 beta (00000312)=0.134432025170604E+02 gamma(00000312)=0.134432025170604E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 312 z1= 1 -.211508286064675E-06 0.000000000000000E+00 z1= 2 0.359319964779404E-07 0.000000000000000E+00 z1= 3 -.754027972763775E-04 0.000000000000000E+00 alpha(00000312)=0.000000000000000E+00 beta (00000313)=0.128577028795653E+02 gamma(00000313)=0.128577028795653E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 313 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000313)=0.000000000000000E+00 beta (00000314)=0.132270538783124E+02 gamma(00000314)=0.132270538783124E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 314 z1= 1 0.219058308550350E-06 0.000000000000000E+00 z1= 2 -.382371628179778E-07 0.000000000000000E+00 z1= 3 0.260484517326933E-03 0.000000000000000E+00 alpha(00000314)=0.000000000000000E+00 beta (00000315)=0.124468861987276E+02 gamma(00000315)=0.124468861987276E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 315 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000315)=0.000000000000000E+00 beta (00000316)=0.134574578569131E+02 gamma(00000316)=0.134574578569131E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 316 z1= 1 -.220107885877310E-06 0.000000000000000E+00 z1= 2 0.384982011014147E-07 0.000000000000000E+00 z1= 3 -.405197799375083E-03 0.000000000000000E+00 alpha(00000316)=0.000000000000000E+00 beta (00000317)=0.125628261574519E+02 gamma(00000317)=0.125628261574519E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 317 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000317)=0.000000000000000E+00 beta (00000318)=0.134454791136559E+02 gamma(00000318)=0.134454791136559E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 318 z1= 1 0.227781478131985E-06 0.000000000000000E+00 z1= 2 -.407627497242546E-07 0.000000000000000E+00 z1= 3 0.508407550446711E-03 0.000000000000000E+00 alpha(00000318)=0.000000000000000E+00 beta (00000319)=0.125694657605291E+02 gamma(00000319)=0.125694657605291E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 319 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000319)=0.000000000000000E+00 beta (00000320)=0.132681020981674E+02 gamma(00000320)=0.132681020981674E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 320 z1= 1 -.237434037797610E-06 0.000000000000000E+00 z1= 2 0.454657998351761E-07 0.000000000000000E+00 z1= 3 -.614348517649299E-03 0.000000000000000E+00 alpha(00000320)=0.000000000000000E+00 beta (00000321)=0.128765190364086E+02 gamma(00000321)=0.128765190364086E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 321 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000321)=0.000000000000000E+00 beta (00000322)=0.135399505544457E+02 gamma(00000322)=0.135399505544457E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 322 z1= 1 0.242718429546013E-06 0.000000000000000E+00 z1= 2 -.487665948076764E-07 0.000000000000000E+00 z1= 3 0.611766368346393E-03 0.000000000000000E+00 alpha(00000322)=0.000000000000000E+00 beta (00000323)=0.127481111723055E+02 gamma(00000323)=0.127481111723055E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 323 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000323)=0.000000000000000E+00 beta (00000324)=0.132689448557875E+02 gamma(00000324)=0.132689448557875E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 324 z1= 1 -.252882011484313E-06 0.000000000000000E+00 z1= 2 0.548362929748492E-07 0.000000000000000E+00 z1= 3 -.593174818229689E-03 0.000000000000000E+00 alpha(00000324)=0.000000000000000E+00 beta (00000325)=0.127936769984736E+02 gamma(00000325)=0.127936769984736E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 325 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000325)=0.000000000000000E+00 beta (00000326)=0.137030979386030E+02 gamma(00000326)=0.137030979386030E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 326 z1= 1 0.253711509245807E-06 0.000000000000000E+00 z1= 2 -.542657027284110E-07 0.000000000000000E+00 z1= 3 0.514699670759784E-03 0.000000000000000E+00 alpha(00000326)=0.000000000000000E+00 beta (00000327)=0.126567252520068E+02 gamma(00000327)=0.126567252520068E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 327 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000327)=0.000000000000000E+00 beta (00000328)=0.132711541587725E+02 gamma(00000328)=0.132711541587725E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 328 z1= 1 -.265811398234570E-06 0.000000000000000E+00 z1= 2 0.595012210985414E-07 0.000000000000000E+00 z1= 3 -.371429647856172E-03 0.000000000000000E+00 alpha(00000328)=0.000000000000000E+00 beta (00000329)=0.128091303400041E+02 gamma(00000329)=0.128091303400041E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 329 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000329)=0.000000000000000E+00 beta (00000330)=0.136226091922240E+02 gamma(00000330)=0.136226091922240E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 330 z1= 1 0.273540552155841E-06 0.000000000000000E+00 z1= 2 -.634648535328530E-07 0.000000000000000E+00 z1= 3 0.203153955867501E-03 0.000000000000000E+00 alpha(00000330)=0.000000000000000E+00 beta (00000331)=0.126673932193310E+02 gamma(00000331)=0.126673932193310E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 331 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000331)=0.000000000000000E+00 beta (00000332)=0.133665354731730E+02 gamma(00000332)=0.133665354731730E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 332 z1= 1 -.289795634871839E-06 0.000000000000000E+00 z1= 2 0.669083966843261E-07 0.000000000000000E+00 z1= 3 0.640951636188790E-05 0.000000000000000E+00 alpha(00000332)=0.000000000000000E+00 beta (00000333)=0.128362310534141E+02 gamma(00000333)=0.128362310534141E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 333 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000333)=0.000000000000000E+00 beta (00000334)=0.134614554406155E+02 gamma(00000334)=0.134614554406155E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 334 z1= 1 0.305035159756648E-06 0.000000000000000E+00 z1= 2 -.687039955568234E-07 0.000000000000000E+00 z1= 3 -.150861182920757E-03 0.000000000000000E+00 alpha(00000334)=0.000000000000000E+00 beta (00000335)=0.124684174584258E+02 gamma(00000335)=0.124684174584258E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 335 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000335)=0.000000000000000E+00 beta (00000336)=0.130933448718722E+02 gamma(00000336)=0.130933448718722E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 336 z1= 1 -.316988962411192E-06 0.000000000000000E+00 z1= 2 0.762433154407162E-07 0.000000000000000E+00 z1= 3 0.269460426284287E-03 0.000000000000000E+00 alpha(00000336)=0.000000000000000E+00 beta (00000337)=0.129072714793785E+02 gamma(00000337)=0.129072714793785E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 337 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000337)=0.000000000000000E+00 beta (00000338)=0.135019998499490E+02 gamma(00000338)=0.135019998499490E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 338 z1= 1 0.324912239309488E-06 0.000000000000000E+00 z1= 2 -.822631310629356E-07 0.000000000000000E+00 z1= 3 -.431475121274085E-03 0.000000000000000E+00 alpha(00000338)=0.000000000000000E+00 beta (00000339)=0.126384314034477E+02 gamma(00000339)=0.126384314034477E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 339 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000339)=0.000000000000000E+00 beta (00000340)=0.132426371124637E+02 gamma(00000340)=0.132426371124637E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 340 z1= 1 -.332402552746477E-06 0.000000000000000E+00 z1= 2 0.875892651903140E-07 0.000000000000000E+00 z1= 3 0.596967546864127E-03 0.000000000000000E+00 alpha(00000340)=0.000000000000000E+00 beta (00000341)=0.126701050005753E+02 gamma(00000341)=0.126701050005753E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 341 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000341)=0.000000000000000E+00 beta (00000342)=0.136755684946828E+02 gamma(00000342)=0.136755684946828E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 342 z1= 1 0.328222640792481E-06 0.000000000000000E+00 z1= 2 -.826700788350739E-07 0.000000000000000E+00 z1= 3 -.713361457323589E-03 0.000000000000000E+00 alpha(00000342)=0.000000000000000E+00 beta (00000343)=0.127946140145053E+02 gamma(00000343)=0.127946140145053E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 343 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000343)=0.000000000000000E+00 beta (00000344)=0.135430062376201E+02 gamma(00000344)=0.135430062376201E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 344 z1= 1 -.331800987280091E-06 0.000000000000000E+00 z1= 2 0.796765905300726E-07 0.000000000000000E+00 z1= 3 0.859062095827094E-03 0.000000000000000E+00 alpha(00000344)=0.000000000000000E+00 beta (00000345)=0.129528409849713E+02 gamma(00000345)=0.129528409849713E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 345 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000345)=0.000000000000000E+00 beta (00000346)=0.134557763374389E+02 gamma(00000346)=0.134557763374389E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 346 z1= 1 0.341624679745054E-06 0.000000000000000E+00 z1= 2 -.777120951778740E-07 0.000000000000000E+00 z1= 3 -.104619516633733E-02 0.000000000000000E+00 alpha(00000346)=0.000000000000000E+00 beta (00000347)=0.125651994710401E+02 gamma(00000347)=0.125651994710401E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 347 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000347)=0.000000000000000E+00 beta (00000348)=0.134781646242342E+02 gamma(00000348)=0.134781646242342E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 348 z1= 1 -.345349867880013E-06 0.000000000000000E+00 z1= 2 0.805531082367960E-07 0.000000000000000E+00 z1= 3 0.117047050246897E-02 0.000000000000000E+00 alpha(00000348)=0.000000000000000E+00 beta (00000349)=0.129740096628456E+02 gamma(00000349)=0.129740096628456E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 349 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000349)=0.000000000000000E+00 beta (00000350)=0.134304568601742E+02 gamma(00000350)=0.134304568601742E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 350 z1= 1 0.353945778648352E-06 0.000000000000000E+00 z1= 2 -.836983616859773E-07 0.000000000000000E+00 z1= 3 -.135438653129641E-02 0.000000000000000E+00 alpha(00000350)=0.000000000000000E+00 beta (00000351)=0.125507904478440E+02 gamma(00000351)=0.125507904478440E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 351 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000351)=0.000000000000000E+00 beta (00000352)=0.134336942728053E+02 gamma(00000352)=0.134336942728053E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 352 z1= 1 -.354545647110764E-06 0.000000000000000E+00 z1= 2 0.881300776429689E-07 0.000000000000000E+00 z1= 3 0.143635408642208E-02 0.000000000000000E+00 alpha(00000352)=0.000000000000000E+00 beta (00000353)=0.129530416776611E+02 gamma(00000353)=0.129530416776611E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 353 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000353)=0.000000000000000E+00 beta (00000354)=0.132884555167290E+02 gamma(00000354)=0.132884555167290E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 354 z1= 1 0.362705662008272E-06 0.000000000000000E+00 z1= 2 -.941936219342032E-07 0.000000000000000E+00 z1= 3 -.157629604020027E-02 0.000000000000000E+00 alpha(00000354)=0.000000000000000E+00 beta (00000355)=0.124741668531824E+02 gamma(00000355)=0.124741668531824E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 355 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000355)=0.000000000000000E+00 beta (00000356)=0.136132726704246E+02 gamma(00000356)=0.136132726704246E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 356 z1= 1 -.351657872352078E-06 0.000000000000000E+00 z1= 2 0.955984982376010E-07 0.000000000000000E+00 z1= 3 0.166844674280371E-02 0.000000000000000E+00 alpha(00000356)=0.000000000000000E+00 beta (00000357)=0.128737376795328E+02 gamma(00000357)=0.128737376795328E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 357 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000357)=0.000000000000000E+00 beta (00000358)=0.136862076027061E+02 gamma(00000358)=0.136862076027061E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 358 z1= 1 0.352747952016524E-06 0.000000000000000E+00 z1= 2 -.935450000616824E-07 0.000000000000000E+00 z1= 3 -.178749117174273E-02 0.000000000000000E+00 alpha(00000358)=0.000000000000000E+00 beta (00000359)=0.126589870052459E+02 gamma(00000359)=0.126589870052459E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 359 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000359)=0.000000000000000E+00 beta (00000360)=0.138519001848823E+02 gamma(00000360)=0.138519001848823E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 360 z1= 1 -.349088281372412E-06 0.000000000000000E+00 z1= 2 0.932496027429347E-07 0.000000000000000E+00 z1= 3 0.183616959153381E-02 0.000000000000000E+00 alpha(00000360)=0.000000000000000E+00 beta (00000361)=0.124137610735843E+02 gamma(00000361)=0.124137610735843E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 361 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000361)=0.000000000000000E+00 beta (00000362)=0.134319960936104E+02 gamma(00000362)=0.134319960936104E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 362 z1= 1 0.348515483525498E-06 0.000000000000000E+00 z1= 2 -.943021246146221E-07 0.000000000000000E+00 z1= 3 -.191602585074082E-02 0.000000000000000E+00 alpha(00000362)=0.000000000000000E+00 beta (00000363)=0.128802105825229E+02 gamma(00000363)=0.128802105825229E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 363 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000363)=0.000000000000000E+00 beta (00000364)=0.135105202411208E+02 gamma(00000364)=0.135105202411208E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 364 z1= 1 -.362087841986568E-06 0.000000000000000E+00 z1= 2 0.100310375070536E-06 0.000000000000000E+00 z1= 3 0.201944324153058E-02 0.000000000000000E+00 alpha(00000364)=0.000000000000000E+00 beta (00000365)=0.123005736308771E+02 gamma(00000365)=0.123005736308771E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 365 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000365)=0.000000000000000E+00 beta (00000366)=0.129057189692805E+02 gamma(00000366)=0.129057189692805E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 366 z1= 1 0.376632258462936E-06 0.000000000000000E+00 z1= 2 -.107987814474699E-06 0.000000000000000E+00 z1= 3 -.211648857921539E-02 0.000000000000000E+00 alpha(00000366)=0.000000000000000E+00 beta (00000367)=0.127030929631902E+02 gamma(00000367)=0.127030929631902E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 367 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000367)=0.000000000000000E+00 beta (00000368)=0.134769684440192E+02 gamma(00000368)=0.134769684440192E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 368 z1= 1 -.383168197283696E-06 0.000000000000000E+00 z1= 2 0.109518492817672E-06 0.000000000000000E+00 z1= 3 0.214970528771153E-02 0.000000000000000E+00 alpha(00000368)=0.000000000000000E+00 beta (00000369)=0.125630506611568E+02 gamma(00000369)=0.125630506611568E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 369 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000369)=0.000000000000000E+00 beta (00000370)=0.133686449093386E+02 gamma(00000370)=0.133686449093386E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 370 z1= 1 0.383078959682664E-06 0.000000000000000E+00 z1= 2 -.106010091870958E-06 0.000000000000000E+00 z1= 3 -.212475795273156E-02 0.000000000000000E+00 alpha(00000370)=0.000000000000000E+00 beta (00000371)=0.128831585203125E+02 gamma(00000371)=0.128831585203125E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 371 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000371)=0.000000000000000E+00 beta (00000372)=0.133106344080954E+02 gamma(00000372)=0.133106344080954E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 372 z1= 1 -.391341847043433E-06 0.000000000000000E+00 z1= 2 0.102998525083940E-06 0.000000000000000E+00 z1= 3 0.214624167365880E-02 0.000000000000000E+00 alpha(00000372)=0.000000000000000E+00 beta (00000373)=0.128996752787842E+02 gamma(00000373)=0.128996752787842E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 373 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000373)=0.000000000000000E+00 beta (00000374)=0.136447938137572E+02 gamma(00000374)=0.136447938137572E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 374 z1= 1 0.390518303454857E-06 0.000000000000000E+00 z1= 2 -.100239374392489E-06 0.000000000000000E+00 z1= 3 -.207010490613665E-02 0.000000000000000E+00 alpha(00000374)=0.000000000000000E+00 beta (00000375)=0.128464956582178E+02 gamma(00000375)=0.128464956582178E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 375 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000375)=0.000000000000000E+00 beta (00000376)=0.131826064416187E+02 gamma(00000376)=0.131826064416187E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 376 z1= 1 -.407823443255542E-06 0.000000000000000E+00 z1= 2 0.998203897908641E-07 0.000000000000000E+00 z1= 3 0.196682689901556E-02 0.000000000000000E+00 alpha(00000376)=0.000000000000000E+00 beta (00000377)=0.130309425386779E+02 gamma(00000377)=0.130309425386779E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 377 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000377)=0.000000000000000E+00 beta (00000378)=0.135757054429131E+02 gamma(00000378)=0.135757054429131E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 378 z1= 1 0.421136849026294E-06 0.000000000000000E+00 z1= 2 -.103665009526296E-06 0.000000000000000E+00 z1= 3 -.175901530279051E-02 0.000000000000000E+00 alpha(00000378)=0.000000000000000E+00 beta (00000379)=0.125827946729059E+02 gamma(00000379)=0.125827946729059E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 379 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000379)=0.000000000000000E+00 beta (00000380)=0.133811889188537E+02 gamma(00000380)=0.133811889188537E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 380 z1= 1 -.428554343066394E-06 0.000000000000000E+00 z1= 2 0.104657112207886E-06 0.000000000000000E+00 z1= 3 0.146858968312442E-02 0.000000000000000E+00 alpha(00000380)=0.000000000000000E+00 beta (00000381)=0.131036692740322E+02 gamma(00000381)=0.131036692740322E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 381 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000381)=0.000000000000000E+00 beta (00000382)=0.134412120788153E+02 gamma(00000382)=0.134412120788153E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 382 z1= 1 0.446937071807061E-06 0.000000000000000E+00 z1= 2 -.114131117493361E-06 0.000000000000000E+00 z1= 3 -.127639825725817E-02 0.000000000000000E+00 alpha(00000382)=0.000000000000000E+00 beta (00000383)=0.129348340843667E+02 gamma(00000383)=0.129348340843667E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 383 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000383)=0.000000000000000E+00 beta (00000384)=0.134947105813353E+02 gamma(00000384)=0.134947105813353E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 384 z1= 1 -.459453414105324E-06 0.000000000000000E+00 z1= 2 0.116063443946288E-06 0.000000000000000E+00 z1= 3 0.111015209319266E-02 0.000000000000000E+00 alpha(00000384)=0.000000000000000E+00 beta (00000385)=0.126540238268537E+02 gamma(00000385)=0.126540238268537E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 385 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000385)=0.000000000000000E+00 beta (00000386)=0.130168217284264E+02 gamma(00000386)=0.130168217284264E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 386 z1= 1 0.473378528232813E-06 0.000000000000000E+00 z1= 2 -.121897205317725E-06 0.000000000000000E+00 z1= 3 -.966840289854400E-03 0.000000000000000E+00 alpha(00000386)=0.000000000000000E+00 beta (00000387)=0.129056952488879E+02 gamma(00000387)=0.129056952488879E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 387 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000387)=0.000000000000000E+00 beta (00000388)=0.133581508278232E+02 gamma(00000388)=0.133581508278232E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 388 z1= 1 -.478560717184209E-06 0.000000000000000E+00 z1= 2 0.122424181965076E-06 0.000000000000000E+00 z1= 3 0.838072139556506E-03 0.000000000000000E+00 alpha(00000388)=0.000000000000000E+00 beta (00000389)=0.125856385164764E+02 gamma(00000389)=0.125856385164764E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 389 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000389)=0.000000000000000E+00 beta (00000390)=0.134758457100295E+02 gamma(00000390)=0.134758457100295E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 390 z1= 1 0.472288948251019E-06 0.000000000000000E+00 z1= 2 -.122450197713713E-06 0.000000000000000E+00 z1= 3 -.729843183041409E-03 0.000000000000000E+00 alpha(00000390)=0.000000000000000E+00 beta (00000391)=0.129065534538700E+02 gamma(00000391)=0.129065534538700E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 391 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000391)=0.000000000000000E+00 beta (00000392)=0.131956506467204E+02 gamma(00000392)=0.131956506467204E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 392 z1= 1 -.490938230572136E-06 0.000000000000000E+00 z1= 2 0.125259044873906E-06 0.000000000000000E+00 z1= 3 0.744165315877060E-03 0.000000000000000E+00 alpha(00000392)=0.000000000000000E+00 beta (00000393)=0.126539190325540E+02 gamma(00000393)=0.126539190325540E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 393 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000393)=0.000000000000000E+00 beta (00000394)=0.133844466001579E+02 gamma(00000394)=0.133844466001579E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 394 z1= 1 0.489982697818737E-06 0.000000000000000E+00 z1= 2 -.126186624218878E-06 0.000000000000000E+00 z1= 3 -.721122122735784E-03 0.000000000000000E+00 alpha(00000394)=0.000000000000000E+00 beta (00000395)=0.126879522707185E+02 gamma(00000395)=0.126879522707185E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 395 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000395)=0.000000000000000E+00 beta (00000396)=0.132038456168285E+02 gamma(00000396)=0.132038456168285E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 396 z1= 1 -.490788019634914E-06 0.000000000000000E+00 z1= 2 0.125620479464591E-06 0.000000000000000E+00 z1= 3 0.632841182270930E-03 0.000000000000000E+00 alpha(00000396)=0.000000000000000E+00 beta (00000397)=0.127102179959738E+02 gamma(00000397)=0.127102179959738E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 397 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000397)=0.000000000000000E+00 beta (00000398)=0.131584531107988E+02 gamma(00000398)=0.131584531107988E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 398 z1= 1 0.499668706436412E-06 0.000000000000000E+00 z1= 2 -.127360235820497E-06 0.000000000000000E+00 z1= 3 -.428772037075028E-03 0.000000000000000E+00 alpha(00000398)=0.000000000000000E+00 beta (00000399)=0.126871726226905E+02 gamma(00000399)=0.126871726226905E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 399 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000399)=0.000000000000000E+00 beta (00000400)=0.136082797752747E+02 gamma(00000400)=0.136082797752747E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 400 z1= 1 -.487344516561950E-06 0.000000000000000E+00 z1= 2 0.121651767752596E-06 0.000000000000000E+00 z1= 3 0.187587823412317E-03 0.000000000000000E+00 alpha(00000400)=0.000000000000000E+00 beta (00000401)=0.128724911867417E+02 gamma(00000401)=0.128724911867417E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 401 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000401)=0.000000000000000E+00 beta (00000402)=0.132282198990289E+02 gamma(00000402)=0.132282198990289E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 402 z1= 1 0.497721444466740E-06 0.000000000000000E+00 z1= 2 -.124773529187400E-06 0.000000000000000E+00 z1= 3 0.859215155135581E-04 0.000000000000000E+00 alpha(00000402)=0.000000000000000E+00 beta (00000403)=0.129669937446892E+02 gamma(00000403)=0.129669937446892E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 403 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000403)=0.000000000000000E+00 beta (00000404)=0.133474509400552E+02 gamma(00000404)=0.133474509400552E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 404 z1= 1 -.506043114607206E-06 0.000000000000000E+00 z1= 2 0.129310653204439E-06 0.000000000000000E+00 z1= 3 -.282959257675928E-03 0.000000000000000E+00 alpha(00000404)=0.000000000000000E+00 beta (00000405)=0.126597770546263E+02 gamma(00000405)=0.126597770546263E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 405 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000405)=0.000000000000000E+00 beta (00000406)=0.135479222659857E+02 gamma(00000406)=0.135479222659857E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 406 z1= 1 0.498765011990314E-06 0.000000000000000E+00 z1= 2 -.131785556210714E-06 0.000000000000000E+00 z1= 3 0.447896889370941E-03 0.000000000000000E+00 alpha(00000406)=0.000000000000000E+00 beta (00000407)=0.127122168229628E+02 gamma(00000407)=0.127122168229628E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 407 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000407)=0.000000000000000E+00 beta (00000408)=0.130765076508555E+02 gamma(00000408)=0.130765076508555E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 408 z1= 1 -.507692412004293E-06 0.000000000000000E+00 z1= 2 0.133806731702363E-06 0.000000000000000E+00 z1= 3 -.688698786068250E-03 0.000000000000000E+00 alpha(00000408)=0.000000000000000E+00 beta (00000409)=0.129438320235474E+02 gamma(00000409)=0.129438320235474E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 409 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000409)=0.000000000000000E+00 beta (00000410)=0.133585513902513E+02 gamma(00000410)=0.133585513902513E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 410 z1= 1 0.520870447692036E-06 0.000000000000000E+00 z1= 2 -.136373389476293E-06 0.000000000000000E+00 z1= 3 0.928765378518860E-03 0.000000000000000E+00 alpha(00000410)=0.000000000000000E+00 beta (00000411)=0.128082046533009E+02 gamma(00000411)=0.128082046533009E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 411 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000411)=0.000000000000000E+00 beta (00000412)=0.138151179860767E+02 gamma(00000412)=0.138151179860767E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 412 z1= 1 -.506120616988197E-06 0.000000000000000E+00 z1= 2 0.136222593837975E-06 0.000000000000000E+00 z1= 3 -.106258702712710E-02 0.000000000000000E+00 alpha(00000412)=0.000000000000000E+00 beta (00000413)=0.124503922460630E+02 gamma(00000413)=0.124503922460630E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 413 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000413)=0.000000000000000E+00 beta (00000414)=0.133781969719672E+02 gamma(00000414)=0.133781969719672E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 414 z1= 1 0.497962912076049E-06 0.000000000000000E+00 z1= 2 -.135041118437713E-06 0.000000000000000E+00 z1= 3 0.111329060110634E-02 0.000000000000000E+00 alpha(00000414)=0.000000000000000E+00 beta (00000415)=0.130602895489190E+02 gamma(00000415)=0.130602895489190E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 415 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000415)=0.000000000000000E+00 beta (00000416)=0.135240133500017E+02 gamma(00000416)=0.135240133500017E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 416 z1= 1 -.501604398636879E-06 0.000000000000000E+00 z1= 2 0.139336597256381E-06 0.000000000000000E+00 z1= 3 -.106470633499667E-02 0.000000000000000E+00 alpha(00000416)=0.000000000000000E+00 beta (00000417)=0.126267838326511E+02 gamma(00000417)=0.126267838326511E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 417 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000417)=0.000000000000000E+00 beta (00000418)=0.138149855024744E+02 gamma(00000418)=0.138149855024744E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 418 z1= 1 0.485352115331649E-06 0.000000000000000E+00 z1= 2 -.132908507207200E-06 0.000000000000000E+00 z1= 3 0.854490913794196E-03 0.000000000000000E+00 alpha(00000418)=0.000000000000000E+00 beta (00000419)=0.126628279828590E+02 gamma(00000419)=0.126628279828590E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 419 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000419)=0.000000000000000E+00 beta (00000420)=0.135328830806847E+02 gamma(00000420)=0.135328830806847E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 420 z1= 1 -.477252007563610E-06 0.000000000000000E+00 z1= 2 0.130566338225760E-06 0.000000000000000E+00 z1= 3 -.678561894914258E-03 0.000000000000000E+00 alpha(00000420)=0.000000000000000E+00 beta (00000421)=0.128435854188705E+02 gamma(00000421)=0.128435854188705E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 421 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000421)=0.000000000000000E+00 beta (00000422)=0.130976982571577E+02 gamma(00000422)=0.130976982571577E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 422 z1= 1 0.497654843272075E-06 0.000000000000000E+00 z1= 2 -.137428382689011E-06 0.000000000000000E+00 z1= 3 0.619979308289963E-03 0.000000000000000E+00 alpha(00000422)=0.000000000000000E+00 beta (00000423)=0.127549522399386E+02 gamma(00000423)=0.127549522399386E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 423 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000423)=0.000000000000000E+00 beta (00000424)=0.136021891819129E+02 gamma(00000424)=0.136021891819129E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 424 z1= 1 -.492285641616637E-06 0.000000000000000E+00 z1= 2 0.136944562933268E-06 0.000000000000000E+00 z1= 3 -.545780937879776E-03 0.000000000000000E+00 alpha(00000424)=0.000000000000000E+00 beta (00000425)=0.123516464779071E+02 gamma(00000425)=0.123516464779071E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 425 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000425)=0.000000000000000E+00 beta (00000426)=0.137420391252512E+02 gamma(00000426)=0.137420391252512E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 426 z1= 1 0.473583776851804E-06 0.000000000000000E+00 z1= 2 -.125811688247339E-06 0.000000000000000E+00 z1= 3 0.419964279736420E-03 0.000000000000000E+00 alpha(00000426)=0.000000000000000E+00 beta (00000427)=0.127422146996331E+02 gamma(00000427)=0.127422146996331E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 427 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000427)=0.000000000000000E+00 beta (00000428)=0.133036720270954E+02 gamma(00000428)=0.133036720270954E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 428 z1= 1 -.483974113329837E-06 0.000000000000000E+00 z1= 2 0.126457763768005E-06 0.000000000000000E+00 z1= 3 -.210583611292524E-03 0.000000000000000E+00 alpha(00000428)=0.000000000000000E+00 beta (00000429)=0.128359399499913E+02 gamma(00000429)=0.128359399499913E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 429 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000429)=0.000000000000000E+00 beta (00000430)=0.132090870728764E+02 gamma(00000430)=0.132090870728764E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 430 z1= 1 0.495960215256795E-06 0.000000000000000E+00 z1= 2 -.131048627694593E-06 0.000000000000000E+00 z1= 3 -.143468125101413E-03 0.000000000000000E+00 alpha(00000430)=0.000000000000000E+00 beta (00000431)=0.129466047377365E+02 gamma(00000431)=0.129466047377365E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 431 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000431)=0.000000000000000E+00 beta (00000432)=0.135200579744086E+02 gamma(00000432)=0.135200579744086E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 432 z1= 1 -.494839151305489E-06 0.000000000000000E+00 z1= 2 0.135098093904349E-06 0.000000000000000E+00 z1= 3 0.471629601434622E-03 0.000000000000000E+00 alpha(00000432)=0.000000000000000E+00 beta (00000433)=0.125894277166990E+02 gamma(00000433)=0.125894277166990E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 433 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000433)=0.000000000000000E+00 beta (00000434)=0.137829718178641E+02 gamma(00000434)=0.137829718178641E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 434 z1= 1 0.478511755602892E-06 0.000000000000000E+00 z1= 2 -.126312645438786E-06 0.000000000000000E+00 z1= 3 -.700698162225882E-03 0.000000000000000E+00 alpha(00000434)=0.000000000000000E+00 beta (00000435)=0.128853808034859E+02 gamma(00000435)=0.128853808034859E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 435 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000435)=0.000000000000000E+00 beta (00000436)=0.132258466669674E+02 gamma(00000436)=0.132258466669674E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 436 z1= 1 -.500667708913834E-06 0.000000000000000E+00 z1= 2 0.132603328846265E-06 0.000000000000000E+00 z1= 3 0.901027401169090E-03 0.000000000000000E+00 alpha(00000436)=0.000000000000000E+00 beta (00000437)=0.129075886300394E+02 gamma(00000437)=0.129075886300394E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 437 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000437)=0.000000000000000E+00 beta (00000438)=0.128552971271777E+02 gamma(00000438)=0.128552971271777E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 438 z1= 1 0.536938708155460E-06 0.000000000000000E+00 z1= 2 -.147109389203083E-06 0.000000000000000E+00 z1= 3 -.935129364894581E-03 0.000000000000000E+00 alpha(00000438)=0.000000000000000E+00 beta (00000439)=0.127812158427911E+02 gamma(00000439)=0.127812158427911E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 439 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000439)=0.000000000000000E+00 beta (00000440)=0.133198569958452E+02 gamma(00000440)=0.133198569958452E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 440 z1= 1 -.546746884451344E-06 0.000000000000000E+00 z1= 2 0.149686457238778E-06 0.000000000000000E+00 z1= 3 0.809269592646860E-03 0.000000000000000E+00 alpha(00000440)=0.000000000000000E+00 beta (00000441)=0.124650109924737E+02 gamma(00000441)=0.124650109924737E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 441 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000441)=0.000000000000000E+00 beta (00000442)=0.134801129218709E+02 gamma(00000442)=0.134801129218709E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 442 z1= 1 0.538387570864522E-06 0.000000000000000E+00 z1= 2 -.147307725218066E-06 0.000000000000000E+00 z1= 3 -.514582329958959E-03 0.000000000000000E+00 alpha(00000442)=0.000000000000000E+00 beta (00000443)=0.125914933023302E+02 gamma(00000443)=0.125914933023302E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 443 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000443)=0.000000000000000E+00 beta (00000444)=0.133360295032736E+02 gamma(00000444)=0.133360295032736E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 444 z1= 1 -.541776626978392E-06 0.000000000000000E+00 z1= 2 0.147364182375700E-06 0.000000000000000E+00 z1= 3 0.178369364065253E-03 0.000000000000000E+00 alpha(00000444)=0.000000000000000E+00 beta (00000445)=0.132106445981137E+02 gamma(00000445)=0.132106445981137E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 445 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000445)=0.000000000000000E+00 beta (00000446)=0.130293021601751E+02 gamma(00000446)=0.130293021601751E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 446 z1= 1 0.575547244640933E-06 0.000000000000000E+00 z1= 2 -.160800048421201E-06 0.000000000000000E+00 z1= 3 0.132396534956740E-03 0.000000000000000E+00 alpha(00000446)=0.000000000000000E+00 beta (00000447)=0.129510247286168E+02 gamma(00000447)=0.129510247286168E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 447 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000447)=0.000000000000000E+00 beta (00000448)=0.132109980804950E+02 gamma(00000448)=0.132109980804950E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 448 z1= 1 -.592774337537555E-06 0.000000000000000E+00 z1= 2 0.165249784550570E-06 0.000000000000000E+00 z1= 3 -.346154371154832E-03 0.000000000000000E+00 alpha(00000448)=0.000000000000000E+00 beta (00000449)=0.129466937211116E+02 gamma(00000449)=0.129466937211116E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 449 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000449)=0.000000000000000E+00 beta (00000450)=0.136530006785259E+02 gamma(00000450)=0.136530006785259E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 450 z1= 1 0.590560502736204E-06 0.000000000000000E+00 z1= 2 -.166477513782000E-06 0.000000000000000E+00 z1= 3 0.464370372594738E-03 0.000000000000000E+00 alpha(00000450)=0.000000000000000E+00 beta (00000451)=0.124487288080804E+02 gamma(00000451)=0.124487288080804E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 451 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000451)=0.000000000000000E+00 beta (00000452)=0.137444281299226E+02 gamma(00000452)=0.137444281299226E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 452 z1= 1 -.565551674046864E-06 0.000000000000000E+00 z1= 2 0.158516185362243E-06 0.000000000000000E+00 z1= 3 -.623584990960878E-03 0.000000000000000E+00 alpha(00000452)=0.000000000000000E+00 beta (00000453)=0.123492807208300E+02 gamma(00000453)=0.123492807208300E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 453 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000453)=0.000000000000000E+00 beta (00000454)=0.136339949626510E+02 gamma(00000454)=0.136339949626510E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 454 z1= 1 0.548764376943911E-06 0.000000000000000E+00 z1= 2 -.155047734128717E-06 0.000000000000000E+00 z1= 3 0.742637998215456E-03 0.000000000000000E+00 alpha(00000454)=0.000000000000000E+00 beta (00000455)=0.124956432913578E+02 gamma(00000455)=0.124956432913578E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 455 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000455)=0.000000000000000E+00 beta (00000456)=0.136121499848857E+02 gamma(00000456)=0.136121499848857E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 456 z1= 1 -.544151501034266E-06 0.000000000000000E+00 z1= 2 0.154325273119785E-06 0.000000000000000E+00 z1= 3 -.938373594417655E-03 0.000000000000000E+00 alpha(00000456)=0.000000000000000E+00 beta (00000457)=0.127309862438345E+02 gamma(00000457)=0.127309862438345E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 457 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000457)=0.000000000000000E+00 beta (00000458)=0.134655838835589E+02 gamma(00000458)=0.134655838835589E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 458 z1= 1 0.553903665426376E-06 0.000000000000000E+00 z1= 2 -.155629970812821E-06 0.000000000000000E+00 z1= 3 0.110848849385806E-02 0.000000000000000E+00 alpha(00000458)=0.000000000000000E+00 beta (00000459)=0.129367220286420E+02 gamma(00000459)=0.129367220286420E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 459 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000459)=0.000000000000000E+00 beta (00000460)=0.134364000675960E+02 gamma(00000460)=0.134364000675960E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 460 z1= 1 -.568530852044016E-06 0.000000000000000E+00 z1= 2 0.158469569113188E-06 0.000000000000000E+00 z1= 3 -.121737512418302E-02 0.000000000000000E+00 alpha(00000460)=0.000000000000000E+00 beta (00000461)=0.127154405196775E+02 gamma(00000461)=0.127154405196775E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 461 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000461)=0.000000000000000E+00 beta (00000462)=0.133070830843115E+02 gamma(00000462)=0.133070830843115E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 462 z1= 1 0.574771114953288E-06 0.000000000000000E+00 z1= 2 -.156698346772299E-06 0.000000000000000E+00 z1= 3 0.123503360150533E-02 0.000000000000000E+00 alpha(00000462)=0.000000000000000E+00 beta (00000463)=0.130283957959322E+02 gamma(00000463)=0.130283957959322E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 463 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000463)=0.000000000000000E+00 beta (00000464)=0.134222252574420E+02 gamma(00000464)=0.134222252574420E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 464 z1= 1 -.593083889201371E-06 0.000000000000000E+00 z1= 2 0.158988242902761E-06 0.000000000000000E+00 z1= 3 -.114393265793547E-02 0.000000000000000E+00 alpha(00000464)=0.000000000000000E+00 beta (00000465)=0.126548164899652E+02 gamma(00000465)=0.126548164899652E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 465 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000465)=0.000000000000000E+00 beta (00000466)=0.134462827252927E+02 gamma(00000466)=0.134462827252927E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 466 z1= 1 0.590894121072286E-06 0.000000000000000E+00 z1= 2 -.154288654768855E-06 0.000000000000000E+00 z1= 3 0.998946231690814E-03 0.000000000000000E+00 alpha(00000466)=0.000000000000000E+00 beta (00000467)=0.128133588242864E+02 gamma(00000467)=0.128133588242864E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 467 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000467)=0.000000000000000E+00 beta (00000468)=0.136879991427512E+02 gamma(00000468)=0.136879991427512E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 468 z1= 1 -.588875918432338E-06 0.000000000000000E+00 z1= 2 0.148184916803819E-06 0.000000000000000E+00 z1= 3 -.835321072080487E-03 0.000000000000000E+00 alpha(00000468)=0.000000000000000E+00 beta (00000469)=0.126931037063716E+02 gamma(00000469)=0.126931037063716E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 469 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000469)=0.000000000000000E+00 beta (00000470)=0.136809093721586E+02 gamma(00000470)=0.136809093721586E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 470 z1= 1 0.580528853944169E-06 0.000000000000000E+00 z1= 2 -.148041498154630E-06 0.000000000000000E+00 z1= 3 0.600306378316256E-03 0.000000000000000E+00 alpha(00000470)=0.000000000000000E+00 beta (00000471)=0.127568966795376E+02 gamma(00000471)=0.127568966795376E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 471 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000471)=0.000000000000000E+00 beta (00000472)=0.133840182608094E+02 gamma(00000472)=0.133840182608094E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 472 z1= 1 -.587167663232174E-06 0.000000000000000E+00 z1= 2 0.153703730977975E-06 0.000000000000000E+00 z1= 3 -.373828837438050E-03 0.000000000000000E+00 alpha(00000472)=0.000000000000000E+00 beta (00000473)=0.126367604503417E+02 gamma(00000473)=0.126367604503417E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 473 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000473)=0.000000000000000E+00 beta (00000474)=0.134963104429796E+02 gamma(00000474)=0.134963104429796E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 474 z1= 1 0.578826100936240E-06 0.000000000000000E+00 z1= 2 -.154538089744622E-06 0.000000000000000E+00 z1= 3 0.135698571851183E-03 0.000000000000000E+00 alpha(00000474)=0.000000000000000E+00 beta (00000475)=0.127396968826036E+02 gamma(00000475)=0.127396968826036E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 475 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000475)=0.000000000000000E+00 beta (00000476)=0.133045814818265E+02 gamma(00000476)=0.133045814818265E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 476 z1= 1 -.589194730355922E-06 0.000000000000000E+00 z1= 2 0.157514244448868E-06 0.000000000000000E+00 z1= 3 -.948196170221308E-06 0.000000000000000E+00 alpha(00000476)=0.000000000000000E+00 beta (00000477)=0.126413685397412E+02 gamma(00000477)=0.126413685397412E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 477 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000477)=0.000000000000000E+00 beta (00000478)=0.133309739721085E+02 gamma(00000478)=0.133309739721085E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 478 z1= 1 0.597314457978179E-06 0.000000000000000E+00 z1= 2 -.159638956197423E-06 0.000000000000000E+00 z1= 3 -.917934686191745E-04 0.000000000000000E+00 alpha(00000478)=0.000000000000000E+00 beta (00000479)=0.126278792963646E+02 gamma(00000479)=0.126278792963646E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 479 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000479)=0.000000000000000E+00 beta (00000480)=0.133938906294525E+02 gamma(00000480)=0.133938906294525E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 480 z1= 1 -.607342357898557E-06 0.000000000000000E+00 z1= 2 0.168340764062464E-06 0.000000000000000E+00 z1= 3 0.173565071526958E-03 0.000000000000000E+00 alpha(00000480)=0.000000000000000E+00 beta (00000481)=0.126436582046682E+02 gamma(00000481)=0.126436582046682E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 481 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000481)=0.000000000000000E+00 beta (00000482)=0.134765932766807E+02 gamma(00000482)=0.134765932766807E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 482 z1= 1 0.612608952851293E-06 0.000000000000000E+00 z1= 2 -.172783630128233E-06 0.000000000000000E+00 z1= 3 -.277317337605068E-03 0.000000000000000E+00 alpha(00000482)=0.000000000000000E+00 beta (00000483)=0.127038200900753E+02 gamma(00000483)=0.127038200900753E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 483 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000483)=0.000000000000000E+00 beta (00000484)=0.136555922573280E+02 gamma(00000484)=0.136555922573280E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 484 z1= 1 -.608744817635930E-06 0.000000000000000E+00 z1= 2 0.176184633103680E-06 0.000000000000000E+00 z1= 3 0.375817271130526E-03 0.000000000000000E+00 alpha(00000484)=0.000000000000000E+00 beta (00000485)=0.126726827827741E+02 gamma(00000485)=0.126726827827741E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 485 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000485)=0.000000000000000E+00 beta (00000486)=0.132370709544796E+02 gamma(00000486)=0.132370709544796E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 486 z1= 1 0.620548197450112E-06 0.000000000000000E+00 z1= 2 -.178464166325910E-06 0.000000000000000E+00 z1= 3 -.479674612029603E-03 0.000000000000000E+00 alpha(00000486)=0.000000000000000E+00 beta (00000487)=0.124437826293125E+02 gamma(00000487)=0.124437826293125E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 487 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000487)=0.000000000000000E+00 beta (00000488)=0.134506493270292E+02 gamma(00000488)=0.134506493270292E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 488 z1= 1 -.618342080109220E-06 0.000000000000000E+00 z1= 2 0.175121721418092E-06 0.000000000000000E+00 z1= 3 0.509274119501696E-03 0.000000000000000E+00 alpha(00000488)=0.000000000000000E+00 beta (00000489)=0.128388998446215E+02 gamma(00000489)=0.128388998446215E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 489 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000489)=0.000000000000000E+00 beta (00000490)=0.132662138113550E+02 gamma(00000490)=0.132662138113550E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 490 z1= 1 0.644367078492009E-06 0.000000000000000E+00 z1= 2 -.175909910842356E-06 0.000000000000000E+00 z1= 3 -.578702365502007E-03 0.000000000000000E+00 alpha(00000490)=0.000000000000000E+00 beta (00000491)=0.125996014881269E+02 gamma(00000491)=0.125996014881269E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 491 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000491)=0.000000000000000E+00 beta (00000492)=0.134509569532127E+02 gamma(00000492)=0.134509569532127E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 492 z1= 1 -.649981370471893E-06 0.000000000000000E+00 z1= 2 0.175585604313079E-06 0.000000000000000E+00 z1= 3 0.651038935345151E-03 0.000000000000000E+00 alpha(00000492)=0.000000000000000E+00 beta (00000493)=0.127244135888369E+02 gamma(00000493)=0.127244135888369E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 493 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000493)=0.000000000000000E+00 beta (00000494)=0.132869525842861E+02 gamma(00000494)=0.132869525842861E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 494 z1= 1 0.667793321405732E-06 0.000000000000000E+00 z1= 2 -.177223368769575E-06 0.000000000000000E+00 z1= 3 -.800553784291323E-03 0.000000000000000E+00 alpha(00000494)=0.000000000000000E+00 beta (00000495)=0.124536292705080E+02 gamma(00000495)=0.124536292705080E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 495 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000495)=0.000000000000000E+00 beta (00000496)=0.134976875168509E+02 gamma(00000496)=0.134976875168509E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 496 z1= 1 -.667496533121679E-06 0.000000000000000E+00 z1= 2 0.182868449113613E-06 0.000000000000000E+00 z1= 3 0.850563541663713E-03 0.000000000000000E+00 alpha(00000496)=0.000000000000000E+00 beta (00000497)=0.128392393011583E+02 gamma(00000497)=0.128392393011583E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 497 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000497)=0.000000000000000E+00 beta (00000498)=0.133354156158310E+02 gamma(00000498)=0.133354156158310E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 498 z1= 1 0.693502811695236E-06 0.000000000000000E+00 z1= 2 -.192743976210866E-06 0.000000000000000E+00 z1= 3 -.921245290995326E-03 0.000000000000000E+00 alpha(00000498)=0.000000000000000E+00 beta (00000499)=0.126817426854673E+02 gamma(00000499)=0.126817426854673E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 499 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000499)=0.000000000000000E+00 beta (00000500)=0.134574913148401E+02 gamma(00000500)=0.134574913148401E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 500 z1= 1 -.702846436581735E-06 0.000000000000000E+00 z1= 2 0.205101345720745E-06 0.000000000000000E+00 z1= 3 0.105538770563826E-02 0.000000000000000E+00 alpha(00000500)=0.000000000000000E+00 beta (00000501)=0.127050103907051E+02 gamma(00000501)=0.127050103907051E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal End of Lanczos iterations Finished linear response calculation... lr_main : 565.06s CPU 599.23s WALL ( 1 calls) lr_solve_e : 3.91s CPU 4.09s WALL ( 1 calls) one_step : 560.35s CPU 593.91s WALL ( 1500 calls) lr_apply : 548.76s CPU 581.12s WALL ( 3006 calls) lr_apply_int : 419.75s CPU 446.53s WALL ( 1503 calls) lr_apply_no : 129.01s CPU 134.59s WALL ( 1503 calls) lr_apply : 548.76s CPU 581.12s WALL ( 3006 calls) h_psi : 254.78s CPU 264.96s WALL ( 3006 calls) lr_calc_dens : 80.21s CPU 83.39s WALL ( 1503 calls) lr_ortho : 2.88s CPU 3.01s WALL ( 3000 calls) interaction : 64.40s CPU 72.67s WALL ( 1503 calls) lr_dot : 1.38s CPU 1.43s WALL ( 3753 calls) US routines lr_sm1_psi : 1.08s CPU 1.09s WALL ( 3006 calls) General routines calbec : 2.22s CPU 2.34s WALL ( 4605 calls) fft : 101.83s CPU 108.90s WALL ( 3009 calls) fftw : 325.39s CPU 341.63s WALL ( 18212 calls) interpolate : 2.25s CPU 2.38s WALL ( 1503 calls) davcio : 0.00s CPU 0.02s WALL ( 49 calls) Parallel routines fft_scatter : 118.14s CPU 127.39s WALL ( 21221 calls) TDDFPT : 9m25.07s CPU 9m59.26s WALL This run was terminated on: 12:14:54 12Jan2012 =------------------------------------------------------------------------------= JOB DONE. =------------------------------------------------------------------------------= TDDFPT/Examples/CH4/CH4.tddfpt_pp-in0000644000175000017500000000025012341371500015140 0ustar mbamba&lr_input prefix='ch4', outdir='./out', itermax=10000 itermax0=450 extrapolation="osc" epsil=0.01 end=3.50d0 increment=0.001d0 start=0.0d0 ipol=4 / TDDFPT/Examples/CH4/Makefile0000644000175000017500000000077512341371500013724 0ustar mbambainclude ../make.sys NAME = CH4 default : all all : check_results check_results: $(NAME).pw-out $(NAME).tddfpt-out $(NAME).tddfpt_pp-out $(check_pw) $(NAME).pw-out $(NAME).pw-ref $(check_tddfpt) $(NAME).tddfpt-out $(NAME).tddfpt-ref small_test: $(NAME).pw-out $(NAME).tddfpt-st-out @$(check_pw) $(NAME).pw-out $(NAME).pw-ref @$(check_tddfpt) $(NAME).tddfpt-st-out $(NAME).tddfpt-st-ref clean : - /bin/rm -rf $(NAME).pw-out $(NAME).tddfpt-out $(NAME).tddfpt_pp-out $(NAME).tddfpt-st-out *.plot out/* TDDFPT/Examples/CH4/CH4.tddfpt-st-ref0000644000175000017500000001256512341371500015247 0ustar mbamba Program TDDFPT v.4.99 starts on 12Jan2012 at 11:54: 7 This program is part of the open-source Quantum ESPRESSO suite for quantum simulation of materials; please cite "P. Giannozzi et al., J. Phys.:Condens. Matter 21 395502 (2009); URL http://www.quantum-espresso.org", in publications or presentations arising from this work. More details at http://www.quantum-espresso.org/quote.php Parallel version (MPI), running on 4 processors R & G space division: proc/pool = 4 ---------------------------------------- This is TDDFPT (Time Dependent Density Functional Perturbation Theory) Sub Version: 0.9 ---------------------------------------- Ultrasoft (Vanderbilt) Pseudopotentials Info: using nr1, nr2, nr3 values from input Info: using nr1s, nr2s, nr3s values from input IMPORTANT: XC functional enforced from input : Exchange-correlation = SLA PZ NOGX NOGC ( 1 1 0 0 0) EXX-fraction = 0.00 Any further DFT definition will be discarded Please, verify this is what you really want file H.pz-vbc.UPF: wavefunction(s) 1S renormalized Parallelization info -------------------- sticks: dense smooth PW G-vecs: dense smooth PW Min 1787 1787 445 113964 113964 14262 Max 1790 1790 450 113970 113970 14264 Sum 7153 7153 1789 455863 455863 57051 Tot 3577 3577 895 Subspace diagonalization in iterative solution of the eigenvalue problem: a serial algorithm will be used Lanczos linear response spectrum calculation Number of Lanczos iterations = 5 Gamma point algorithm lr_wfcinit_spectrum: finished lr_solve_e Norm of initial Lanczos vectors= 1.841314958090108 Starting Lanczos loop 1 Lanczos iteration: 1 z1= 1 0.000000000000000E+00 0.000000000000000E+00 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal alpha(00000001)=0.000000000000000E+00 beta (00000002)=0.172013913000150E+01 gamma(00000002)=0.172013913000150E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 2 z1= 1 0.124507717706288E+01 0.000000000000000E+00 alpha(00000002)=0.000000000000000E+00 beta (00000003)=0.476624382768189E+01 gamma(00000003)=0.476624382768189E+01 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 3 z1= 1 0.000000000000000E+00 0.000000000000000E+00 alpha(00000003)=0.000000000000000E+00 beta (00000004)=0.135459644298635E+02 gamma(00000004)=0.135459644298635E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 4 z1= 1 -.355850969842812E+00 0.000000000000000E+00 alpha(00000004)=0.000000000000000E+00 beta (00000005)=0.127188556203638E+02 gamma(00000005)=0.127188556203638E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 5 z1= 1 0.000000000000000E+00 0.000000000000000E+00 alpha(00000005)=0.000000000000000E+00 beta (00000006)=0.134777630974300E+02 gamma(00000006)=0.134777630974300E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction End of Lanczos iterations Finished linear response calculation... lr_main : 4.39s CPU 5.59s WALL ( 1 calls) lr_solve_e : 1.35s CPU 2.51s WALL ( 1 calls) one_step : 2.28s CPU 2.29s WALL ( 5 calls) lr_apply : 2.23s CPU 2.24s WALL ( 12 calls) lr_apply_int : 1.70s CPU 1.71s WALL ( 6 calls) lr_apply_no : 0.53s CPU 0.53s WALL ( 6 calls) lr_apply : 2.23s CPU 2.24s WALL ( 12 calls) h_psi : 1.02s CPU 1.02s WALL ( 12 calls) lr_calc_dens : 0.31s CPU 0.32s WALL ( 6 calls) lr_ortho : 0.01s CPU 0.01s WALL ( 10 calls) interaction : 0.30s CPU 0.30s WALL ( 6 calls) lr_dot : 0.01s CPU 0.02s WALL ( 8 calls) US routines lr_sm1_psi : 0.00s CPU 0.00s WALL ( 12 calls) General routines calbec : 0.05s CPU 0.05s WALL ( 50 calls) fft : 0.51s CPU 0.51s WALL ( 15 calls) fftw : 2.37s CPU 2.36s WALL ( 132 calls) interpolate : 0.01s CPU 0.01s WALL ( 6 calls) davcio : 0.00s CPU 0.01s WALL ( 11 calls) Parallel routines fft_scatter : 0.73s CPU 0.74s WALL ( 147 calls) TDDFPT : 4.39s CPU 5.59s WALL This run was terminated on: 11:54:12 12Jan2012 =------------------------------------------------------------------------------= JOB DONE. =------------------------------------------------------------------------------= TDDFPT/Examples/CH4-BOND/0000755000175000017500000000000012341371517013003 5ustar mbambaTDDFPT/Examples/CH4-BOND/CH4-BOND.tddfpt-ref-s2-2.gz0000644000175000017500000102474012341371500017162 0ustar mbamba‹¾¾@OCH4-BOND.tddfpt-ref-s2-2Ü][sÛ8²~ϯ`íÃVT'v4®ÞÊÃTærfk.>IæRû’¢eÚÖYYÒP’3ί?Ý$¡ Þ6«S\y&±c4Z$ðõ‡îF|‘Ð×u¾¼ÏÓÇäÃ×_{ý!yº”—Î-Éz“æ›u²\$Ü|›ÝÆE’nðWŠ]I^¼(Ä><ÌÖɪRC?b¯dy—l²d¹Êëå6ŸfÉÿlÓÅfû˜|óþúÝ7ïßÿœ¬·³MVê¸[æÉUûzö¸§›~.jyL7Y>Kçë¿%«y–®³dºëE_¹¾L¾›¥‹ÅòóçY’m’t~ù*ùûerýð¼¾¼z»\Üf‹õeòcºAE‰à 8¥˜H^ ÆÜäo{MÉ/ï~H6›ÕÕëן>}º¬®ç"[¯òl½^^.óû¿¼JʳE²ÚÞÌgÓâBqò„¤²Å¦úEšÏÖ³Å}r—/q(p\>-óâu,ó,¹Í6élŽB›R[ǧ¾þc»Üd—«‡U5ä×ižÎçÙÓ‡›Îìs9&3Ãfd½¨ˆp6ýçí$!.ÉðËåæ¡Ô÷[ñí»‹§lZˆx™C!”*5ý8Û¥Ræð;Üe"ŒÓúèÎVšÒ?÷š4;üÎ%‹i²G?€bÒ[Ú£“R»ƒïœ3*`@ý`7,7rêð»RêE²7mÏ@é=y? r{ŽÿxÊ’õr¾õ‹-%Ùì>[&Btu3Ï+¨§ÉºX!ùï—ùlóð¸ƒÜv_}êébúy¹Næ³E–æˆõjIµ^eÓMŽc0MçÓjá){ü´}¼A8ãçû¾ÕÕ¿“ p…ð/e!“á5 7lІñNîóåvq[þ¢ ‘Ë*Ö|ù¿Yi])Âózæiè·4'¿"JÄÕ"Å?O5ý4&¥É“5¼J6ù3±ÊfI†–g÷hj$¶»ÏÚí}5Ÿ/iùÂNÅœ'ÙŸÈ•É ÒäºX÷X]×wéãc𬖳Åf?ØeÓ<ÿøénJ&ÿÑèUB°~À»ÅVœÎ§ìcægãçõ‡#ÝàǬ7h§÷›‡êC—s\:+@ÜÎòìˆxÙ{9&Óýoße/ßMŽqúý#þÊÓ¯þaqãÐ1î› ÆËß°êë›ÿòdVJ úá{hÁ…u¼»T=€[+™ÑÝ=dÕCàq®l{áï{(ÜÕqÂß¶“Ʋ>=À8f¡OYõ0Ò*°²ãÎá`>@r&”TÔÞÞÃχà˜Æùèìáçƒ Í w¶»‡¿¼"à ë˜y0 gÖ™öÏó!‰‰;»{ìîƒ)ä!º{øûVkƒŒ÷!"=¾ÌÅ¿Á-Ÿ 1FÀ\ö7F´Ú¨þƬâ ú£ÐN³²}b‘#¼ ÎLw1r®à†rhŒ¸2 Úô4ÆÂ´¤#¡§1!ƒ®ûØ#Q„“ZYÖƒ"ü|h)Á¨m1 ]culŒ†ãœôè±7FD®f=Ì×χC¾­íIŒþƨ@Š!Æ(¥EjeýQÃé‡HîŒÛ•á-¥Ç´[Q³hZëÃÎéªN¦èšü1+ .¥ÐÇàw+<‚^ƒíXQ‘V-åLÓò 6ø”èþ oŒ -ÒŠè º£•‘3é‡#~uÜG°2jä”ŽÑ ŒQh)úc]mSM4Tã»,½%ù:ÇHºr ÉŸ­âé2»»›M³Å¦ Û/_/·›×Óy±Ê/o²Múñž|æŸ/yÿÚ‡¶M Ég«u²ÞN§ÙúnK0ÆÁ·uûŸ-n3 yu¡o½w»wùËË›ÑõùûYcÀµÀØë.ÏþØf‹ésò¸¼Åèj‘bHU…æoÒü>#áRÏ>Ž.?ü."=]U³Å%º‰8h*9Çý°¿}˜}äù›JX1M~˜‡4N‘?#…Å›Ä{Þr'L¸ÀR¡0ì… „í^ø'¼ 劬R>¤Ã°ïe]¦4ø%– Ž®}ÄJ™PÚ]¹\®vó˜» ñj/Q|ûÌ}â„Àíuñ߆ŗt†á1xKW«ùóÇùl¹}µi–â­-0Ö/~MÂaVeŠÚúÄäIa«Šå竇ôeu |ò¦å²^’=¾¡e‹kl0JqW²>/l&ÞT­|¿e³û‡MaVEâ‰Ì;X!ué]_ì`]ᇌ9ñW&&qí¥haòýDÿÕq8']1€r!;))°aVÛ lk06F"­ÑêÝ€¼:@©³TFÓŠ©p‘U]¹o³Ü qï°d²Û2õÁ˜è…1….ˆS’ã’áÀÉCŒEšÚ0vŽ€TºÂ˜’L™=Ž0“¸öÆÚEÿŸì· cðM‚G žÄ„S·\£»X¬[{bª5u€ÆXð×HyWÖ9‰k€¦]t$Ä$ë Azi݃ñ‡7 4ÄêÎ8'ÐWVN !&êlœ ˜GjÉŠŒàɈIöĘTÂ)¤gÆUÁÑ«5µ/~eËÐ;[[dbS“¸öÆÚEGBLê|ˆIõµÌŒ°pJ¥‚¦ÞÔA ¼j5Ã`Ò¹ÐèI\{4í¢#!&°ÒH°HK’×C@sqé¤Õ}0Nìd†yL?Ø9ÄK`;Ý­/!&Ý“˜Ðó¡…)¤;&¦ZSûâ§œ±e½rk?3‰k`¬]t$Äd·˜LOb’¸B8@ ƒ‚c©ÞÔ`|ï1Yв4v×M»èHˆÉÆ<&tv”¸Câ²îÌ b¢¿F—½%&Ñå*·’zƒ;ƒ2Ü å˜,<¦ÖÎ_BL¶'1Yp\±¦GÄTkj_ü¤vRy #å&br“¸öÆÚEGBLî|ˆÉõ$&0¸¸ââL1‡9&¦ZS;hПÙå˜p©f"Î&qíuÐtˆŽƒ˜xmêx™¤Åµ#Ö9Ž 󘸋K7º wCˆ©è¬SR+À+`'$¦rzº1†—ŽŸ`pƒP®ÖÔ±ø!©ÊcL4…rœOâÚ#k1ñÿìDûhz&¿ºZ!”ÐêxLaSh„°Æ{LŠ–hÄ$®=švÑ‘S$ùVƒÌä„\8çËzƒ# í9ÍZ@¿iXŽ © ¨ê œaä C9Þ/ùMuÆYŒÅ2&ˆ)lêH |މ¶’ß&q팵‹Ž„˜Î'ùÍ{&¿­Ä…ýXÇÊ}Øb ›:<&éwLÐ_PM«™œÄµG@Ó.:bŠ$¿©VÅ!1H†sF 0œãÒÍÕy‰A»rÔY(Í1(EÛ§$¦¾Éo¤IŒ %œ‘1…M틟á) ³û¹áMĤ&q팵‹Ž„˜Î'ùÍû&¿¥ÑÁÏà÷€˜Â¦.7[ Y]£ÄØË6€¦Êh×´G@Ó.:bŠ$¿1 rÚIƒ×,pЃ<&ì Ìi…sÈÆi¢ ”Ž´&AIcEeÅ'"¦¾Éoˈ£Ñ#1Œ…¡\ØÔ1@®®n‰ž¹iJTíšöÆÚEGBLç“ü潓ߖQž•âk.b ›:<&r†+Ir¦šB9ŸÑµG@Ó.:bŠ$¿ýEKî¤À¸Œô˜$SÔ›ú70ùѽ¤gI4wE‘íɈ©oò¯DpmñVt±=r¸+6µcŒSFß瘄³MS•Ñ®i`¬]t$Ät>ÉoÞ;ùí4FÕZikEà1Õš:V3ô¬}ŽIR‘I4Âg´CíuÐtˆŽƒ˜D$ù}A…1ŒŸ¡ —aaÖ€¤§iÊÇxLØÙqN ä ‰IôM~kÅ…ÔTñ-xcª5uÔÊY͹Ï1Ö¼cUF»¦=‚±vÑq“8Ÿä·è›ü¸RHá¨ê% ¦°©Ãc²º*@IÛPÇ$ªŒvM{4í¢#!¦xå·¦´˜t|8““ßR9áLñü¬¬3 ,ґà£IP§ åDßä7=>JûŒŒÊ>)lê(à`÷˜ éQe´kÚ#k 1Oò[ôN~£x±o]XÇ6uxLο/.+7!ŸÑµG@Ó.:bŠV~sÊiQ<‘¢„š‹K¥ :;Ü)k´ívzŽ=&쬥fŽsdtÕ~ 1õN~c˜¤Ar¥hOí8Ç6uX"Ó;ï1IË›?ŸÑµG0Ö.:b:Ÿä·èü¦Ôa8å9‡Ä6u¬f Cï1k$&ŸÑµG@Ó.:bŠV~s‰¡®èn— ( ‚qViüa˜ÇDÛqŽžgÒZnNIL½+¿©:ˆq«5³aŽ)ljǘÖzï1áÐ6$¿…/çµG0Ö.:b:Ÿä·è›üÆxƒ2Š cX†Mí«™DCôûâRšFbª2Ú5íд‹Ž„˜¢•ßrp' 2ƒq¢Úèí1 \M§œ€“ƒB¹¢3~ äœÜKyÊä·è›üÖ–áÌ¡‡…~IÊÕšÚ1fœ–»“¡0Ve´kÚ#k 1Oò[ôM~£ù= TlÊS­©ÃcÂèÍ×1I%e1A•Ñ®i¯ƒ¦CtÄÑÊo:¾iAZt{, |$ÅãÌGÓgÀ;¹å4Øý%\$¸–åÙc§"&è›üF\pa„FN¡\­©c˜áÞc2Ü5xLPe´kÚ#k1Áù$¿¡oò[ÐÑX W&]ü®5uxLҸݮÎr1UíšöhÚEGBLÑÊo:ö„¶ûµQ$ Ü•sèð**„ÖsLØÙ1 ‘¸‘§ å wå7Whó†v¼‚§ êMí£*ï• ct1ùrîP{cí¢#!¦óI~Cïä·®Ðâ1v¶rëM“RÕ9~HRíÐøŒv¨=švÑ‘S´ò›ÓóêJ[IG¶°A¡ú¸ncœb™S¨b`“£g*Ð_ât¨SSïä·r‚Iª28Z§ÖÔQÇDÃZaLXh: |F;ÔÁX»èHˆé|’ßÐ7ù ÒPÖ É“õ¦Ikë³¼’JŽ@Se´kÚ# i 1Å+¿¹°‚F¡“‘Ô Kò $Óœ5ÖÈ]N¥hÊÎÆ0ÍÁhÝÕùKˆ©wò›¡(ŒMá¸V®ÞÔá1r®÷˜\y@I c>£j`¬]t$Ät>Éoè]ùm¸ÕBXmœ =¦°©ÃcB3ÚU~Å›ˆÉ—s‡Ú# i 1Å+¿™VLÐÊôÀÜÀÊoÎ\ñډѱ¨ÞÌÐ4ÔÙ`ˆ Î;%1õM~£/Âå eí‘”ZS‡ÇD³ÞcBß°Écª2Ú5팵‹Ž„˜Î'ù ½+¿•2Ü Š­pá®\ØÔá1YÿâŠâÐgÖ°c"}9w¨½šÑq“ŒW~3ô•¬f”i;ôØ®Œ4º•R=&N'ë³tXœq'$&Ùû؈ ŒK)¥„raS‡ÇDÑq5˜èš†<¦ôg™„Ú#k1ÉóI~˾Éoe@kÇ5ÆaS­©Ãc¢çV½Ç„ÕDLUF»¦=švÑ‘S´ò]%.­ÄèÓ)]½e§¿ÇÄåZ§Q‹è1agÚÐÃÉà”ÄÔ»òÛRa Q‚ <¦ZS‡ÇD»úÆèaeÖ€1_Îj`¬]t$Ät>ÉoÙ7ù `wºpHbª5uTåraý¾¸tB5<Ç$å$®=švÑ‘S´òÛQŠ @Q('ݧ§<(Ý,z5u²3 ŠCB4VÑyãÂÔcêüFrÖôŠ#tÃó˜Â¦Éò]\ ¼| †1ŸÑµG0Ö.:b:Ÿä·ì]ù­œ¤[º ù]kj_Íp…ßÅÿ´Ö˜”¾œ;ÔM»èHˆ)ZùŒBG<8Œ=@ðÜRxL‚j#©‚‘k7„Õ êŒñŽPL3Ð'%¦ÞÉo¼ Eçý£;V~‡M““¼Ç$tÓ™_Òg´C팵‹Ž„˜Î'ù-û&¿£ú`Š8œë˜Â¦®ç˜€ûø_1n›<¦*£]ÓM»èHˆ)Zùmñ‚׌+7¢3  Ïcᤦ­q#ù€ÎåyL ã^žº§$¦Þ•ßš[£RÌɰò;lê8]€YævPôÆ0æË¹C팵‹Ž„˜Î'ù-{'¿1¶Öœžê2á –µ¦Irëß’¢˜â «™òíP{4¢ã &­ü¶œÞQ Ñj4¥i¢òe mú t¼Ä€T­Õ´­§éͽ§#&ÕûØi•£#ج3Aò»ÖÔu´®ã~ç·8U¦cþ,“P{cí¢ã &u>ÉoÕ»ò[¸â”,ô`u°+Wkêð˜”æ¾ŽIñÆ·¤(_Îj€¦]t$Ä­ü¦÷Ma¤A:(îÄPÉX㌠òmzz Çd¬“à8Ȉ'%¦¾Éo%”Ê1mЩ>&¦ZS‡Çb‡±¢º­cUF»¦=‚±vÑ‘Óù$¿Ußä7íá€R­ÞÉïZS‡Ç¤QÞc¼©øMÉI\{4í¢#!¦hå·:w„‹â­v1‘ÓƒD,1p¡˜ì19ÚÎÓ’k®³:óKˆ©wò› bªZ¹@ØÔá1IÉv9&MoâQ>£j`¬]t$Ät>ÉoÕ7ùMï\’”—°6xƒE½©Ãc2bwè%4½%EUíšöhÚEGBLÑÊoÑW•†bdÀ;ë¯I « :[–žßZÇD{ £ÐNuRâ—Sßä·‚an¥C'妮W„3ë+¿#Õ&bª2Ú5팵‹Ž„˜Î'ù­z{b@jòIcÁAqµ¦‰ÛÚyL¬©\@ù³LBíд‹Ž„˜¢•ßÚŠbZhɬðTIá1I!…%%æ†zLØY  wÓ§|$EõM~KürÖâôiìÊÕš:<&Sž–T¾íÙýwï¶ìʪ+‹~O{˜+@7àÿlKv•Ûh n»‡#ˆškÏË9¨4z·å¬$)ìÕØ¥h7Ù‡LÏ¿yUüÈÖ ™m0ce{Ò,ÍÆ7ø0&$îØžJøñ³·E3 =˜Äíü`†d®L¸q«ä͘ÌY Ù]7}Ãl5X¾æ$Åv¾6ù{À$ËâwÖ=’–„]F«Üš¥™çwOçwzßjójìV´ëìNCÏ&yŽø-Ëâw¶wOfª¼rÚ¥‰»`Hñöc²S¥Í–[Ñ®³;E3=˜ÜÎo‰Ù:^v.[[¹ðÂ$;‹´S¹‡ñz˜JJ"Ep~ø/À´l{°°þ]˜Jå+ß.M“’¤Oçw²‰)~Ý^&uv§ÆÆ¡‡ÓsÄoYxldk‘+šÝ.ßff´uïÿùµ‹ð‹æ3ŲÊîÍ8ô`r;¿Ù<•t#§Ø”¬‹b“1S½AÌòmo+÷~X„uiwy¿¹•“Uñ;Ù†Tr \_o—&¾ò>#gP뢣c ÿøÙ‡LÏ¿eÙö$¾dÀJ}%¥^š0&tŸ˜(µ¡^ÑÜ^&uv§hÆ¡‡“Ûù͢ȠQ ¤·Oå‚2%Nº‹Ý>•Sz)/¢†suë_€i¹ó;ëÝ·¶ÏêÚS»4™ÄS¸ý˜P÷ª½—ßÝÎ]gwjlz0=Gü–Uñ[÷_Yóf/Í•ÆÔ,MâgNÛe¯NÑ\Šv“Ý)šqè!Àäv~3‡õnÓbcØ¿_2‘yÄÌ1$Ú>•Ó0P”lý_eL«â·]eŽE·Hj?¦fi6‰—Ã}WŽ”Ýtú˜¤üøÙ‡LÏ¿eUü&kSS.RJªO嚥 cÂ÷‰ SäÎÛ,]Šv“½-šIèÀ”ÜÎoÖ70äœu+»wå°è.…Œ%Q´Ë˜(X_§ÜCؾLiUü¶>åI÷·±¿›¥ c"Î_ùÐÄ›âŸÝ©±qèÀ”ž#~§eñ›Bd´«UBuçw½4aL„ðÆ”;§réV´ëìNÑŒC&·ó›'²é® Ö²cBùîü~M9 `ý[°L J_þŠlßdLiÙöê7¨œ+ñ»Yš0&~ ÞïiÏ©wò›n/“:»ScãÐC€é9âwZ¿õÅǤ¡j+×,Måÿ0¦½·Ù­h×Ù¢‡Lnç·~Ä%a.¢{„ý»r¥ÓSÄ÷w“fè†æÿ 0­ŠßöÊÒ„ƒÍ¢û LÍÒ„1éõã’ ±7Œ ñŸÝ©±qè!Àôñ;­Šß"f‰’¤Ôw嚥 cøœ˜¼ÆÁvŠæR´›ìNÑŒC&·ó[wRD¶ïˆÌÁr“1…¢Ád­Èú÷ÞeL1DˆL6ÂQ¾º•[¿³Íc`ÛÓr¨'ñÖKÆ”â§ó›lÿÕ©±KÑn²;56=˜ž#~§eÛýÕC6ë|©.X¶KÆdýü7c’Ô»+—n/“:»S4ãÐC€Éíü&ý ‰í¨Ì©%mÅéQÆk¶{ 2î #x?LJ2•´ê–î› –iUüfsƒ`¦ZÕ}Ìvi˜rþœÊ‘}@»í&»ScãÐC€é9âwZîü¶žW1‡¤îü®—&Œ©¾çÊqÂÒÙÿç»»ÎÞÍ$ô `Ênç7EÝÂé~8™í÷®ƒe*©(cRzçkµƒeÒ-/›kJ*󪦼Þù-&á “î–ª­\½4aLúwúøÊ#ô¦=çO;w•Ý©±qèÀ”Ÿ#~çõ—æ‘Blç@µø]/MSÉŸN©×c’?S,«ìNÑŒC&·ó[q¹D²‰Ö¯{k»–Bº\‚y•Ý))úð{°¬ÝG>ü/À´*~—`;%€C}%¥YšøÊÛô™›1aá+Ï—¢Ýdwjlz0=GüΫâ7Øk}a” Í]¹ziƘRüt~'è #ÌôãgwŠfz0¹ß˜_nˆ©D,¶ÚŒô°µûŸh.›Œé壟D»UýE`Z¿u;ì\•bNÕÀËfi2‰äwÚ3‡.0]Šv“Ý©±qè!Àôñ;/{~G–ÂÂ¥¢ÙíÒøm–BN¿Œ)÷&ñæÛÈ»ÎîÍ8ô`r;¿QXÁ²î?CÚ ÷fLú/RF’^çk»ŒIŸÕ§õ?PdÚ6þ/À´*~ E’÷ÂÚÁ²Yš0&³ ¾“á~§Æ.E»ÉîÔØ8ô`zŽø—mO2›çmFÿõ•”ziü6KÖzóaL©7ó+ß^&uv§hÆ¡‡“ÛùLìÜ(ƲàŠT3¦é}uYyÏî]9}XR ó—,ó¢øƒ]rÌ)Ýà—¿5Ö,M“ ,¼“„Ø“ ÊŸÝ©±qè!Àôñ;/‹ßF`õëÖü5Šo—fŒ)}zL8u,Ë­h×ÙÛ¢™„žLÅíüFÊv'„䵩Ú=•ˆfñª¿“hλŒÉ,˜ØL,¿©1•å—‰’ ²Ê)‡Ú] ^šM{Ÿ¹r”RÏ] ÜS,ëìNCϦòñ»¬ŠßQ8Y7d)$ÕÛ¬Yš0¦€òéü–÷#^Ñ\Šv“Ý)šqè!Àäv~Û`pŒJ\çíS9PgѽÚÅèMÆ¡ˆ Ey×ÿ˜–;¿±ÝE£˜9ü¦fi6í9]cè­‡µPG.(w;wÝ©±qè!Àôñ»,w~GÝvÙ‰¶yp5ÓߥcŠñî1a.Ø¿ ýøÙ¢‡Lnç·eƒ¹•§$aoA°aºdçýA²¾Æwû˜^ÖtÖaAEùÅ7iÙó;"ØEJëìª^ÖK³iÏ,ŸiÏ%–^ÝFÞuv§ÆÆ¡‡ÓsÄï²Üù­/ÂT¨ Tâw³4cL"Ÿ>& Ý­ÜÝÎ]gwŠfz0¹ßÖ"€ÙXì˜P¾“É|ÝðA¥Š»“>Ì ¨ŒIÿï›§reQüÎA_(,Dÿ2µÆT/MSI—TÊ;Ö:%ýøÙ‡LϿ˪øÍÁTÛº¿ÝmþS4ÍÒ„1EÂcìù1•KÑn²;E3=˜ÜÎo(æN­už“@ÚfLÄÊx q˜ß*©™±þssZðåý`Zx©Ì1ŠõTë>ó/cj–&¾òІ¿Óž¹»•»§XÖÙ‡LϿ˲íIÄ—‹Y’U[¹ji˜ ÿçT.vú˜b¸½LêìMÑÌB¦Ø~uƘ¬Q€¬ñ —”žš1A°[À€wÝôaÓ¾tG÷Íá××3¯±$Ökж±…ÊÁ¢]šøÊGþôÊ)0%ÿåÃÝÎ]gwjlz0Åðñûú¼çE“mÌP|uÌ@õ6k—&ŒI_7Ÿ))&qtŠæV´ëìNÑŒC&·óû=ä$…!`غÄk¤'èöUTpÚu°Ô‡³˜!–Ìü¢»ÀõõÌk,QJ9g2óR¹ 4KÆo/ù÷´g ^]Šv“Ý©±qè!Àôñûú¼çE“mν¾×ÙfrTûÿfi˜8|¼rX÷!þh.E»ÉîÍ8ô`r;¿•èähGkéÕ‚µÉ˜B2_ Ò¿r°;%Eæ±TâôÅvëë™×XÊœõÝÂPJÝ.P/MÓnjжu!úî1ÜŠvÝ©±qè!Àôñûú¼çE£?zóo d—ªc LÕÒ„1QùÕ˜RîÌ•S„ùñ³;E3=˜ÜÎo`›t™RYt°É˜‚äÂÖ5.;½x=¬[Hë€J1|u+·ÚùÍŠÒ)È«M¨v¨—&Œ‰èÓùÍ!wF„k±üøÙ‡L¿¯Ï{^49ëŽ ä«K¼ÍÒ„1I(·3gêÍ¥h7Ù¢‡Lnç·Í…S¤d[¹¹ÒS3&FŒúpˆJ7”s¼&»<\Dÿl_ìcº¾žy%Bý,lhL©XÚ¥ cbâOEÄcº§XÖÙ‡L¿¯Ï{^4‘„‘#×s嚥 cJá3ó‹u»Þ¿ã¥h7ÙÛ¢™„žLÑíüÛ¤6²Rv®»½Ø$å‚6 f—1¾ôIÆæuÿLqUüVb{%³‡ªXÚ¥ cbJŸÛ!—ÎË/Æ?»ScãÐ3€)>GüŽ«â7Ùµ¶ÄY$¥zA½4aLÊݕ˅©³•‹—¢ÝdwŠfz0¹ß`½ÄE‘ºØ¨ðMwb’š`VDfˆFz:¥ä1&}ˆ3+2Íþ`ZxIQÐîÉ HÕùÝ,Í“u@ÜC‡1Å{ŠeÝ©±qè!Àôñ;.Ûž°Ø}Ð7ì_`j–&Œ)—W—žíiŒ·—IÝ)šqè!Àäv~Û5\ æ-Ræ>’‹F±…“¼dXÉ/3§e`z=œth—YR~õ| ˜VÅoÝAb±Ï¢rIm—&Œ)Åôј¢rèN]Šv“Ý©±qè!Àôñ;®ŠßÌQ÷Jú…è/¿¦fiƘ?'&¥wó;ÆKÑn²;E3=˜ÜÎoÝ‹•̘Ð$ì½áJz•l¢Dý±l2&±Qêô:Òû0-¼Œ¤(«[̪íÒ„1¥ò{»ÀÚµ;5vO±¬³;56=˜ž#~ÇeÛ°q±ºg úT®^š0&3mü0¦ý+) 1?~v§hÆ¡‡“Ûù éÿE›ð–7Û”ôˆØ}‹P¬¯¦¤§bL¢Oë'¥¸A±à7iUü¶ûȤ˜üšYþ—1ÕKÆ”ß6n¯ƒØxã¥h7Ù‡LÏ¿ãrç·‰³ú#Ð×3Uâw³4aLËÇ] ¼¯B:Ew;w½-šIèÀnçwTÖ-U4µÖî6ï1&ÑíÄ»©,žŠ1).%°|úvxÍÿ0Áªø]Ì2Aý[…˜ª¥‰Kj€ßS9夯ñÇÏîÔØ8ô `‚çˆß°,~ë7­4–¬ç+`ª—fŒ ‡1é›­W4·¢]gwŠfz0¹ßJób–@l}ޏéÇT†3®éVðå˻Ř09ûZƒEüæV6<¿ò«!׌©^šøÊGÝÕß5†’;WRà×Èûov§ÆÆ¡‡ÓsÄoX¿mâ+¥ŒÖöR‰ßõÒŒ1½çK¼û˜„zÀt+Úuv§hÆ¡‡“Ûù“Ým°Ë´˜x>¨»fL ÍžB6j—1%ÝCŠþ³C 8Eµ¦Uñ;•×!€ñÀR1¦fi˜ôs¹§¤0u[RàR´›ìNC¦çˆß°(~ëþ‹Y9Å~õ‰I½4;•ËñÓc’Cï/ÈŸÝ)šqè!Àäv~›šª 2EÑn5X*éÉfðº‡sÚ¿ía ¨;i`* Ó^ƒ¦eñ“©ÊƒnÊ+`ª—&ŒÉÎÍî*S9¸í:»ScãÐC€é9â7,¼Ì™”Âf4óûŠ1ÕKÆ” Þfv¿½S4÷Ë:»S4ãÐC€ÉíüÖ­gexÁ,vÃÆ=ÜëTÎ.ÙA!ݺÌOüëS9µ€tŸc àߦUñ;Šæ•  ]ŸÊ5K³iÏ„¿.©)÷^~—¢Ýdwjlz0=Gü†Eñ;Ù«YQ0¦¦ù­^š0&aþô˜pî1& ?~ö¶h&¡gºß `&ÒP¬‹bóT.3ÔÎÂlÿºÛùm’5aß¼’‚˶'¤ß[¶†ÈPÝ.h—f³ ¡|NåtŸëUx{™ÔÙ‡žLøñÅo3{úŽÓ#ªëÍÒ„1]²á{ÿOØ9ÊEøñ³;E3=˜ÜÎoeL`£@¹Ý¢Ø¼+§»?»ð¹ìz~‡HÁøZÓ8~Ñ(îúzjŒX‰H`‚ꀥ]šMâ¡rט”N¯Þ^&uv§ÆÆ¡‡ÓsÄo\¿Ca­b{Áçºó»Yšù1%ú¸ `×+/E»ÉîÍ8ô`r;¿£neEÅa×ÁR×Ðæ9PÆ]Ïï`c‹­*™7*ü 0­Ûžd,6¼%V/¿fiæ’ª›Û«ÆÄšb:5öñ2©²;56=˜ž#~ãjç7èN]ì\›9T~LÍÒÌÁ2ÈgoLÜ&ñjçn²;E3=˜ÜÎoý¥Äv¥$§X65&Û½¤)e] »“xƒ]¶ñQ‘Cø¦.ÛžèG `ƒnHšK¼ÕÒ¬Æî>&ÝÞc§Wo/“:»ScãÐC€é9â7.ÛždÌ!%ÎRÛžÔK“·™€½SäÔÛÿß^&uv§hÆ¡‡“ßùmÒ,ØÄ({â·¬™|BÅ:Çe¯]À.ÁF©g3Š} #ø–øËžß…9¡]ÅÆêvA»4«±$÷´gýX»Œé6ò®³;56=˜ž#~ãjç· ½WõW’+ÆÔ,ÍöÿŒŸ®\sâ÷‹†®vî&{[4“Ð3€‰üÎo²Ã~κÅ´×.ð¿ÿ+œKÑßGÎAdÞ¼]Êq‰Pt˜IŸþ&0ÑòÀKÝÐëÖOB¨Oåê¥YÉçw ÏžŽI÷Ë:»ScãÐ3€‰ž#~Ózçw`²™’TšaõÒ”1ýú1ÇÐ-šO;w•Ý)šqè!Àäw~©=‹yoo2&J³q(²åÝÎoRv8ÃÛÄã›À´<ðR?û3!”êå×.Í4¦$¿· ôCêÔØ=ŲÎîÔØ8ô`zŽøMË/“yë¦#S5Œ°]šíÿ9~ú˜Bé‰ßtO±¬³;E3=˜üÎo,ɪ]´æwÝ0“aõWÈ ×Ý*Æ„Lz/J43•1-w~§×Þ´0@m{Ò,ÍÒ¯K*¤ÞËïn箳;56=˜ž#~ÓªøKÖ_@Ô-ƒTÂd»4ÝÿÃçmroÿO—¢ÝdwŠfz0ùß(D¬e`“1¡it6T.ðæVîõ0¤ÈîïÀw·r/ôõ’ͺîo5KSV^>½rYßWûbù7»ScãÐC€é9â7­ŠßÊö“Y’!døÛ`Ù.Í&ñ¦rÿm|s˜.E»ÉîÍ8ô`ò;¿ÑNÖR¢€1λ‰*Æ“.Ebs’™›PVŒ)&6½¤@ ·Ô×€iUüV6bú  ÝùhÓߥc‚_ϯĽ“_*?~v§ÆÆ¡‡ÓsÄoZ¿Mº)õÝ\S³4{›)·þ0&¤Nó‡?{[4“Ð3€‰ýÎoH±(Tƒ‚D”]KsÅÍôgBú;ÙdLJ-9ê^:|˜x¹ó[«Áf–3B=%¥Yš2¦ß»r9H瀅ïvî:»ScãÐ3€‰Ÿ#~óªøú² ›Šc?†¿ÀÔ,M5&úeL9u4&¾í&»S4ãÐC€ÉïüåK_fqP6z$_ŒÉ®ÎÖæŒaº«SȤ»GsŠ0·¿ü`Z¿s Á~î9é³²Öi–¦½r/;Ý›1u,üìNC¦çˆß¼*~ & /©‰rÛ¥ÉÛ,äx÷1Ù˺C³™~üìNÑŒC&¿óÛ6TŒ˜"2í5X*é  +$#óþ²ôa)‘YoߦUñ›”ñB±ÃB¨ý˜š¥c¢ß^¹ÄÒ‘ øR´›ìNC¦çˆß¼*~“î^“‘Sí`Y/ÍÞfÿÕ˜¸×ÇÄ—¢ÝdwŠfz0ùß1€õªëŸ]„·Œâþ÷9å×d´)XaóTN.XÄÌ«0ò7âxUü¶Ê $Pˆ›Ù…õÒLcŠò9•è UåKÑn²;56=˜ž#~ó²í‰YëëC¥15K³ŽwW.eL=éö2©³;E3=˜üÎo»©®|Iô½nöç[Œ)—K”‹n·Äï×ÃúÏ¥TÌ[¨|•1-w~Ûd@"LR]âm–f÷1!~NåŒén箳;56=˜ž#~ó†ø]‚¤P¥ªó»Yš¿ÍèfLv)Ò/ùU´ÿfo‹fz0‰ßù­ª×?¤x«ÁRIOÖ-œ `àBvò´Ç˜Ì¼ Á&ËÄoú1ɪøMÉn¡ýò¤Tâw³4©1L¿ŒIÁ¤c­#—¢Ýdwjlz0ÉsÄoY¿CÆú–Ý.UÂd³4cL?S’ÔјäR´›ìNÑŒC&¿ó;»3§8%.»žß9ë÷W’¢RÉÛ“>œ‚˜§o@Ý\˜V;¿u7k¶µI°@}‰·^š1¦ÌøaLÔÛÊÉÕÎÝdwjlz0=Gü–åÎo°›U6{;V÷˜Ú¥YÓ{ðÍ‹1É{þ—W4w;wÝ)šqè!Àäv~N²˜Ø‚l¸ã¾“­œŠ™†+®í2& $9² $Phú&0-¼´€ vTØLI©—f:f›•³ÍóîÔØ=ŲÎîÔØ8ô`zŽø-«â·¹»ë^I7…*ÆÔ,ÍNåB¼{L”ÝäŽÆ$—¢ÝdwŠfz0¹ß‰"EÔým.;Ãt_ŒI0ÊæÞ ²·•{=\R°­¤]þú*cZµ=J$J{õ/Tª+)ÍÒÔó n“%uÓåeÒdwjlz0=Gü–Uñ[wÕ"8ÙÖ¡ÚÊÕKÓ›ßñž’J)¤^Ñ\Šv“Ý)šqè!Àäv~ç"RÌAƒ”ùÐt$@Ř8J%†PisJŠ=œ%š]}UcZ¿u_iÖIô¡¿§ríÒLc ¿wå¸ô¦=Ë¥h7Ù‡LÏ¿eUüNÖ]u‹$TYë¶K3ÆT>såIQæ·t)ÚMö¶h&¡gSr;¿³]cÖ hκýܱTz1&6ãX¥\6„i“1M»L9HŠ ¿9%%-w~‹â4Ý*a¨ý˜ê¥i¯\þLâQfØiâMw;wÝ©±qèÀ”ž#~§Uñ;}MØ$²òþÊÿ\â­–¦ßåž+G)ö&ñ&øñ³;E3=˜ÜÎïL ˜ÂÊw‚µKn2&HfCiöx!ïµ ¼¶[òÆ—bú&cJ«âw.úsG³—ê¹rÍÒÔóû×ó‹B·Æ.E»ÉîÔØ8ô`zŽøVÅï‡Õ¯[ ÖWRš¥é©\øÕ˜Þ„Ø+šKÑn²;E3=˜ÜÎïl—ÕmGÉ\¿7“’C}Ñäþ¹LT1¦h“Ô¿úå¿ LËžßúÝ))ÁÖ(®^š1&¡_ÆKGüN·‘wÝ©±qè!Àôñ;­ŠßÁF Ù”ÛX*¯œviƘÞ7ÙÞ§rԻě.E»ÉîÍ8ô`r;¿3EÅ•EôOÎÛŒIRf¶P Ç»ˆ¢"™«ÑWÝÒªø­‚Óšò õˆðziVcú¹~@O.¸í&»ScãÐC€é9âwZ¿Í#±þ‡dª,ë¥é©\¸ÝŒ(t¼rÒ¥h7Ù¢‡Lnçw¶ÃzzY(sÚÕ˜c hÖ@Dó™•cÒ‡1gÔÍÉüHï_€iyà¥Íî," ;Û¿rA»4u°Ÿ»r LÎïT~üìNC¦çˆßiÙó›ÍÍ(U÷˜š¥É”Ô’Ëý6³+$a2ßFÞuö¶h&¡gSv;¿³nÄB»ôÖ9±Ç˜”Úäa&Qê»A·ðz8 B¶»)_uÈ«â·mò­?(QI•ÆÔ,MÝòg/RìhLùR´›ìNCϦüñ;/w~KÐ/E¿Ž¢?¤j+W/MOåès*G¹×ü–ïvî:»S4ãÐC€Éíü¶û} ‚"R”ëm2&V‚ˆ”ÑKw,íá$IX_N%O•ó¦eÏïvpQ0qUcíÒô®ß:&cy¹sy5vy×Ù‡LÏ¿óªøb¯çhe\]h—fŒ ñöü&dêˆßùR´›ìNÑŒC&·ó;Ûä%ÆìVØeLlàKdŽ»§r6|OÿÉd‡Vóª¦Uñ[ìà"’„ò–®ÿÛ.P/Íú˜?ߘ±£1åKÑn²;56=˜ž#~çå—Ê^KÑ~ÏÕ•”fi6Wž?,´|zûÿ|O±¬³;E3=˜ÜÎïT8špÉ6†iƒô¼.XÌ!hóJÊûá„uc’Íßø‹À´*~b±ÖýHJLÍÒŒ1ÑÇó‹‘±s3_Šv“Ý©±qè!Àôñ;/ÛžØS›½j`ª—fwåBüœÊ!uÓíeRgwŠfz0¹ß¯q@í5w“±΢ ‚m?&}¸p`öå›~LyÙó[¿@FkePoåꥩç}Nå qçä7ßFÞuv§ÆÆ¡‡ÓsÄï¼*~£Ý^x)µ‰*`j–fŒ ã=WŽ õlOË¥h7ÙÛ¢™„žLÅíü6 8³I;ÍÛ/ÆDŠá çí>&{X$'ÓMÊ7,˲íIvå:«ýã`Y-ÍNå¤|ú˜€¨Wc·—IÝ©±qèÀTž#~—eñ›Ñ†ŸE³pªN嚥)cÂOç7èN¤S4·¢]gwŠfz0¹ßº™RÖZ€’òØj0Ò£Ô^—ÝóÆE;¼v _wÖøMñ»¬Šß…”:’ØP8©S³4uø½+g¯ªN]Šv“Ý©±qè!Àôñ»,‹ßvÏú;*R*£¸fi˜RŽŸ>¦ˆ½æ·r+Úuv§hÆ¡‡“Ûùm¦ÛŠeé]w9fëv,õaÝÍQŽ…é«WRʪø­ôOW GÎõ$ÞfiêÇT>§r°³•+—¢Ýdwjlz0=Gü.˶'f*¦[ÔÕÀT/ÍNåR¼ÿŒ:}Låö2©³;E3=˜ÜÎoIŠ$Å*»îXÄ45»lïfS1OÃÃÒ7Oåʪø^™8WîÍÒì®ÜÛ‘û=í9‡+¿í&»ScãÐC€é9âwY¿u–cŒºy¯hv»4Ó˜b¹Ý)Jo®|¹í:»S4ãÐC€Éíü޶ëœt‹»}LT0êöôÑD›så¬OÞz˜³nKòWmOʲíI±ð¨}¿ü¦fi¦1…_wýŸÛåö2©³;56=˜ž#~—eÏoFH¹èï'Píù]/ÍS,?¦ˆÙ?ÊUÂüãgoŠfz0AûÕ½H(úF×?±²—m?&ÌÊx¨dÝí˜9áõ0¹ÓaÑßÙ÷€éúzjL7´„öÿPªÎïvi¦1ýöÊY¯—LâŸÝ©±qèÀá1â÷õy/Ø•#d)Öúò·hš¥ c’üñc2«ÿ~üìNÑŒC&·ó[Œ´& û{ÈNä»IQ L¦ żÓ7û˜$èãÌA¿ùb»ÀõõÌkÌt6;¥TÚó»YšÏ•ûeLœ|Ván箳;56=˜#~_Ÿ÷¼hìê3ÔN˜«Îïfi˜óíùú²÷Åo—¢ÝdwŠfz0¹ßœ)r@Ö ¨õ ì2&›d¬€,¬Äk»ó›Š>VôI€ôUÆ´(~ëVœõïÉ:e+‹fiƘ²”c’Øcåüãgwjlz0=Fü¾>ï…¢yŸÅ³½ß¹êcj–&Œ‰Êg®æÐq°„p)ÚMv§hÆ¡‡“Ûù­´•ŠZö.c‚B¤{ר¼“v§¤èÃ&àÊ‹s}Ñéúzæ5–RŒ!Û$*Ò×KŘê¥Ù©\Ï””@Å?`p+Úuv§ÆÆ¡‡ÓcÄïëóžM&}ïDs{ÐÍC%~7KÆdM77cÊïŽ#¯hn/“:»S4ãÐC€ÉíüVÎ’Å\‘2ÍÏÆêS¹LúùYSÒ’íS9#k1#Y—ÅO宯g¡ÆÐ,‚AÿF¹™]Ø,Í“ÐçvA)ÝÿøÙ‡L¿¯Ï{^4Ö\€r›CZ½Íê¥ cÂwÈ‹1ÉÛ Ä)š~üìmÑLBϦèv~3b´³ ûžßI(óEÛíüÖ‡­WÄ,B¾Ø`y}= 5fàk­mOš¥ cJ±Ü· Ì!´Lñjçn²;56=˜âsÄï¸*~Û8 3c Ibµÿo–&ŒI©Í}*‡ºñꜘDøñ³;E3=˜ÜÎo¬|EYOA›¶Ûùm¢õÍ !Ľ­Üûaë:§ 5w™û`ZöüVöfæTúõQ\½4aLf€skLöt§Æn#ï:»ScãÐC€é9âwÜxYLïŽÕ̯vi˜l~3&ýuôŠæwŠåßìNÑŒC&·ó›”¬É`Oü63',v¸†€)o» èÃÀL<_¸ü/À´Úùº·qV,o£’ÿS³4aLœÃ§ó;bÇ%âÕÎÝdwjlz0=GüŽë¶'JH€¬I™þM»4cLéógDÊÒiˆ/“*»S4ãÐC€Éíü&¶™±&~ٺī¼ è_Tq)*°á®“>¬Ï…¬OêÎ÷‹¶'×׳PcÊv#30+©j¬Yš0&2ôûT.JGüŽéÇÏîÔØ8ô`zŽø—^%þ,LjÆÔ,ßf\H>“ý«S4÷Ë:»S4ãÐC€Éíü&²Sý#›ÑíΦc ERŽ º¡ÛeLÖÃdC6#ÛŒ´oÓºç·Íí,kÆÔ,M“”ß»rQ:—x•`ÿøÙ‡LÏ¿ãªø]´ˆÅœ©c¨-)š¥ñÛŒ„»Çcê‰ßp)ÚMö¶h&¡g¸ß¤,BzùêbغÄû?Ãý(MS+ú"ßíc úë*ló2c”oŠß°ìùM´"(bȵS½4aL6dáfLðfO^ÝFÞuv§ÆÆ¡g`øæ$Þëë™×XRÖ§%݇ÅÊ©YšÊEþLâ)Ľ­ÜÕÎÝdwjlz0=Gü†eÛ“’„Èìs®ï1ÕK3ÆDév„L½S9¸½LêìNÑŒC&·óÊkäe±IÁÍ>&sÅ šA7s»wå’Müˆú¤þ“)|ó/,ÛžH"‚(’9Ô¶'õÒìTî?“xì.a§Æn/“:»ScãÐC€é9â7,¼4Œ—’Yþ¦fi˜ à}óRîåâ=ŲÎÞÍ$ô `B·ó[·01óÒØÔ˜ä5êR·®¯q“ ðý°1$³> s_Þ&\¿ Qà AYdú[cíÒ„1Å„÷©œùàv:¿1þøÙ‡žLøñW;¿ssb³cª—&ŒÉúoÆ”;o3¼Ú¹›ìNÑŒC&·ó”=rJÖýiÏZ÷Š-8ë^n×ó[ŽJfôíŸ2¦/Nâ½¾žy%»<¢„îôc5í¹]šú1}NåHrïäoE»ÎîÔØ8ô`zŽøËžßlm€IB jæW»4cL>“$îˆßxy×Ù¢‡Lnç7€’2¿|Sz6,• 9—X?‡Mw»ú‹æ§@ò7mOpÙö¤€B$Øà¶fDX½4Ÿöüñ•ç:rÞ^&uv§ÆÆ¡‡ÓsÄo\¿õ'rIA·ÖÕ©\³4~›™ÇõGc²³ýNÑÜŠvÝ)šqè!Àäv~˜m¾ÍŠ5oÝÍ))’‹î+0FÝÅêžn—1H J‘ ¿º•[íüJ2óöXu~7K³I¼)|\RÍβScW;w“Ý©±qè!ÀôñWÅoL‰Qì<¥z®\½4~›éûùãǬoÓž^Šv“Ý)šqè!Àäv~C,1S)\"¦ùØÉZcÂbþŒÁ¦¨m3¦Œ9JN&Úý 0­Šß„/ƒHëE«,›¥ c2+Ó›1%„ž\p)ÚMv§ÆÆ¡‡ÓsÄo\x)Ð~™cí•S/M“ÈgJ*è»ÓcB÷Ë:{[4“Ð3€‰ÜÎoëÜ™‹þv,_ÎV#‰ò¤ºõbL¢˜(‚ ‰Åîo|˜hÕó¨$¢`ã$Ëzi¦1ÅßÙ…œ^üÙ«±ËÈ»ÉîÔØ8ô `¢çˆß´ÚùÈf3ᜰ­S/M“¾lîý?D†Î©ÁŸÝ)šqè!Àäv~C4;D 6~iaCU1¦’czÝ”Øôc2’EÉ><%Lñ›Œ‰–^‚î+_ÒĪÁ²Yš» ü2¦ ñ›î)–uv§ÆÆ¡‡ÓsÄoZöüNˆÑ®ßrʵ0Y/MSŒ|3¦X8w„Iº¼ëìNÑŒC&·ó¢$Ý…Y½Ûþ`³)d´K¸ŒL¸g÷z8*ÑBTv!ßeL˶'Jw£îī寎Ù.Í:¿3Ý¿ÝÖ÷Úèö2©³;56=˜ž#~ÓªøýDM9þWLÍÒ„1þL°ˆ9§c’?»S4ãÐC€ÉíüÖ×n@fÀTï5XÚÙ“¹ËÆ1Ì›·«Îï€ÖÕ‰ŠŒº÷ýf»­v~—¬Ü/°þmr®û˜ê¥™ÆÒí+O©·•»Ú¹›ìNC¦çˆß´Üù­äŠHwë/ƒ¿Œ©^¿ÍôgéfL ©W4w;wÝ)šqè!Àäw~Ø«7†Ì¬›Œ ìñHElÿºÙǤ366Óñ…ò¿Órç7ókXº¾¸¨¿›¥©ÓgJ ™ |§Æîvî:»ScãÐC€é9â7-w~#Ùõk4n:¿ë¥ñÛ %‡ÛÁÒ¬r:í|·s×ÙÛ¢™„žLìw~ S)lnåæ©œuëp¤¬SfóT.½¦lêw¡¨HsÏ”&^¶=ÑߺVGÉÊ©+?¦fiÖùMø¹+G]£8¾½LêìNCÏ&~ŽøÍË/ƒi#°`©:¿›¥ câB÷‰Iä÷¬ ¯hî)–uv§hÆ¡‡“ßù Ìx_6â캆ìXMA-î2¦hd‹íãã2o‚ú`Z¿s”)gˆü÷€¥]šM{føLID–Æ?»ScãÐC€é9â7/‹ßví¼¦¶Am­[/M!Ý~L‘º~Ì|+Úuv§hÆ¡‡“ßùmã€tð:KÜnJ %}:fÔó[%c"R7‘/ˆþܾ L«âwaeSK1W—x›¥Yç7}zåCélåøR´›ìNC¦çˆß¼*~[—q±ÁŠ€ÕÍïvi˜ Á‡1é/£Ó•ËòãgwŠfz0u:¿ufÃp)ío2%åu®fœË„µ]?&ý•qÔ IÎ ²û¿ÓªøMÂ`ŽÚ¥²Öi—&Œ)ÿþ("ôXù¥h7Ù‡LÏ¿y¹ó[7`6ÐÃøN=¾©^š0&ø}›Eà^ç7ßíÜuv§hÆ¡‡“ßù Ù¦ ¤l½1{Öºf©D¤?º¤nXvý˜ÌŠ­ÅUÛ7,yÙóÛIÄT’¼|ý×%µ^šLâ጗T£“»¼ëìNC¦çˆß¼*~ëÆºØ¬?Èõ©\½4aL1ð}bã[BtŠFŸ½-šIèÀ$~ç7 (E;õß»Äû"=š¶ä`·q¶S fzb _&Y¶=Á¢T1›Óÿ_`j–&Œ‰ß‡*/_y%Ñ^9¹½LêìNCÏ&yŽø-«â7ÛŽ~!l‡@©Y¿Í @ºOLbèNI‘KÑn²;E3=˜üÎoÉŠJzâæVîu#Lwh®áv.·«1¹}‚ÝòM£8YíüÖ? ¡TÊ5KÆD1S†žƒ…\íÜMv§ÆÆ¡‡ÓsÄoY¿Í»^l–4‚Tw嚥ñÛ J(÷Ÿ±HyßwŠæR´›ìNÑŒC&¿ó›ìbPEÑt£GòÝùͺµ(ʸtÈ»žßY´J1ç¾/ÓúÀK)ØV©ÄŠ15Kϯ’?½rh ¨`úL±¬²;56=˜ž#~˲ø]ô‡ŸCÈú~ý{] ]š2&¸“²ì:Àt+Úuv§hÆ¡‡“ßùMì 'f2Ý~ÛÁ2³Ø\9›Æ»{W.sŠf‡6…xeÙóûuk_Bb®O嚥‰ç—Ý߈л)·‘wÝ©±qè!Àôñ[–ÅoÒ"Îhïh¬Åïzi˜ŒÙ\ÆL¹ L·¢]gwŠfz0ùß(¤l‰K2Õbã`íå.PH†,t;¸é.`‚93ZTùê”Y¿¥H—Q´#Âþ.M“RÁÛó¡k{"·¢]gwjlz0=Gü–åÎo}ñi£ö×ßõÒ„1éË®·Ybz7µE“îvî:{[4“Ð3€)u:¿£Y(åI”v®»½;¿CQL ±˜{Ùî””l1è{"~³Á2­Šß¨–È„ $V§rÍÒlÆÏ´ç©sÀ’.E»ÉîÔØ8ô `JϿӪøÍ’Ú…9Õ㛚¥ cJäú3JáØ¦KÑn²;E3=˜ÜÎïXPК· Ta—1%Ö êÃLÌ›îú°dà`Þg™¾ÙÇ”Åo›?" \‡2TrA»4aLŠØw)fÇNƒez+Úmv§ÆÆ¡‡ÓsÄï´*~§¤› ²¬TG¹íÒLc t{~‹n(°L—¢ÝdwŠfz0¹ß‘3›K * ÚÍã= sÈ9I‰1GØj°‡“nJØ|ˆS™Câ¿Óªø-Œ­Ï”bu³]š¹¤R¼ïcZGE§Á2]Šv“Ý©±qè!Àôñ;­Šß¢ôÊ/‘ü˜š¥Ù©\Lw“~Ço{ §h.E»ÉîÍ8ô`r;¿£î ’u0Ý”M?&!±Ef)ÍK*ÆDKÐÏ,D\˜/þ/À´êù£}qlÔ떔fiâùÅú~ºôÓeäÝdwjlz0=GüN‹â· ¡N…¥˜"R “ÍÒ„1åÀw ›ƒr˜òŸÝ)šqè!Àäv~GÐ?5™éI2HÝöüÆdÚ.ê›|›1e4CaI¦5}˜ÅïLí­bÍèuKJ³4õ•O·ƒ¥n¼z#ÂSùñ³;56=˜ž#~§Eñ[kWlf{Ⱥɮhv³4aLœà㕃 S¹~üìmÑLBϦìv~GNH¹ä×ÝÝÎop çŒÖ¡¹Ûṳ̀" Èÿ˜òªç7¦¨¥CâX‰ßíÒlÂÇW^¤7¾)Ç?»ScãÐ3€)?GüΫâwÌÌhwà×3¿š¥ cÂ7µ~˜@~”xÀt)ÚMv§hÆ¡‡“Ûù¦írŸéß´íÇ”É"EÑ`Øj°|=¬Hä×X™oÓjç·Øi| œô;¬:¿›¥É©œÁ‡1)…î´ ä«»ÉîÔØ8ô`zŽøWÅosøçD‘8–Šf7KÆo12¼û SîÓ¥h7Ù¢‡LnçwŒ LH µâa‡ô¼“IÞ‘ ë <Ì'0UŒ)ÇhXtK¢¯ŠoÓ²øMÙ¦‚þÁb¨€©^š0¦Ìÿј¸×.oE»ÎîÔØ8ô`zŽø—^fF,f”Õø15KƤ¿Å_Ë7!ö€éžbYgwŠfz0¹ßZÝ6Ó\tWÅ™¶ÄïðÙ~"o«WÙt°Ì!–×IÀó&¨¦ÕÎo…0Ö/ÏÆYAÕÇÔ,M4¦ËÍÊ­%¢LW;w“Ý©±qè!Àôñ;/w~Ûè3ë"‘zÿ_/M“þî·Y2õ[^ÑÜíÜuv§hÆ¡‡“Ûù]ÈÌHÉRâø2¸í|¡>cÔ½X X0§­Ë×ñ@È!±àÜ¢î_€i¹ó›ƒrÀlŸI©S³4›]âgÚ3rÏ)ßíÜuv§ÆÆ¡‡ÓsÄï¼ÚùM%€~Åfø€cj–Æo3ó\¼·rúz_k‹¦\íÜMö¶h&¡gSq;¿uS€¨œ's´±;Àd2Q)A‰)<)áÚÕ˜Šñ,ó²SÁ/SYíüVb—ö0k³]š0&ÛÝÞŒ Rì8X”«»ÉîÔØ8ô `*Ͽ˪øM(©è΋‰ëËfiü6‹ÿi°´]HöS¹í&»S4ãÐC€Éíü¦Pì‚ôwTD`—11Z2ÀKóØeLlÓ6ÁªLß¼’R–Åo»…^~¿R ¼l–&Œ ¥›1én·ã.PnE»ÎîÔØ8ô`zŽø]–=¿_Nú¢ÐWlmW/M“ê_Ƙ0u:¿Ëmä]gwŠfz0u:¿Ãë0 IÈÛŒ)AQl ÅL…w§¤ädF±¯yDR¾ÙÇT–Åïõï#³T.©íÒ„1aøeL¡ÄŽ»@¹í:»ScãÐC€é9âwY¿‘‹î®í(§™ÄÛ,MSB¼/ñ wÚŠüøÙ¢‡L®ø­›©l#ÓEL†¶þkÚ`L)EÒg•èÎb×)%“Ù¼…hîkð/À´*~c ‘3¤’*ÆÔ,ͦ=g¹5¦¨°ß¿Ë¥h7Ù‡LϿ˪ø0JÎEóºmø LÍÒ„1Ù[úú3"qÏ] \Šv“Ý)šqè!ÀäÛž$ÝFq¶ã1yϬÜaLIÁ,õû!Å]wôš dS€ñ›}LeUüÌ#&}ÃPLÍÒlÚsûåµ :}L¥üøÙ‡LϿ˪øú]„Bv½ñcª—&Œ‰K¾ÛL¶.0)ÿñ³7E3 =˜°ýê¬hˆ%›ùKPŒÆM‰²M†‰%gkHÚíüÎIR±åºübç÷õõ,ÔXˆõ¯8-¹š]Ø,M|åKøÜ.Púýa®vî&»ScãÐ#€ ÃcÄïëó^(™[̺Ôã›ê¥ c" öþ3êÏ1úwå0ÜS,ëìNÑŒC&Wü–ˆ FŽ!ØÕ˜b¯Þí½v×á$…Ãh.š_ìcº¾žyéŸHlf[Õ}Ìfi2‰'Ý“ògö·r.E»ÉîÔØ8ô`zŒø}}Þó¢ÉÑvIÖg¶b©Yš0&"¹Ç7ÙÝ6¿óýøÙ¢‡L®øl@B3_ÏïI¼;Œ r)ŠlÊ¢ì‰ßï‡CNvÂ_<•»¾žyéöˆ &"ŠX_o–&Œ)ÁçvA”˜{ŒéR´›ìNC¦Çˆß×ç=/;˜FÈZÉbÕÇÔ,M"ÝFy]¥ðéR´›ìNÑŒC&×ö$q¡ÂY’2Ç·€Éš  ³nÇ8±þ¥·Ú^“µ(˜g8Ì'Úý 0-¼ÌdBÛë†MÕùÝ,M“àÇ%5ZYt€éžbYgwjlz0=Fü¾>ïyÑdÌÅñ­ß¦TíÍÒ„1A*wSÉ=Æt·s×Ù¢‡L®íI²%¬¸bè°·•³y³…m’/…¼3-¯‡•¯FFû¸¾L«¶'‘•üe}©b%4KÆÄïÖ‹1éÛ*t€éò2i²;56=˜#~_Ÿ÷BÑ2æÏSý6k—&ŒÉ6ýן1CâŽÆ/E»ÉÞÍ$ô `ŠŽøm·dúµ(áÄMƤl'¢²%Ìáe¸·çǤlÕn‘4(ßÜÊÅÕÎoÝâÛfõSü¶KÆ„ºßº“&ÿJ Æ«»ÉîÔØ8ô `ŠÏ¿ãªøm§]T„Ä Y«“zi˜^“ßE£» èlåâ¥h7Ù¢‡L®í Ûf*[¿@fNe“11dÝ·êï„)ï?Œ­!ÕŒh¿ L‹â·ÝAËúN጑*‹fi˜0Ê=W.‚ ïÇ„üìNC¦çˆßqUü6A‚PJJ•øÝ,MS€ÏQn¹¯§8EC?~v§hÆ¡‡“k{¢Ürb.¬¨ºLfÛ­|)K4k¼…V¤Úó•o¡èÇ–à›Öº××3¯1»€FŒ•€Ôwåê¥ c‚ðë`w4¦øi箲;56=˜ž#~ÇuÛÝ7âJcj–Æo³·ñíÿÂÛŽ(t¦¤ê+ïÇÏîÍ8ô`r;¿Il*\²IJd;Ž=Æ¢xV^RSØ™/Ž×ÃI·’!pü*0­ŠßIÿ@3† ø—1µKÆ9Nå´$ü+)ºçÿñ³;56=˜ž#~ÇUñ›í|4½”Òºù­Y¿ÍtƒþêR~Û‰ôŠæR´›ìNÑŒC&·ó“²yÛÊåù½Ã˜bdPÊ¥ÛádKü~=LúްcL(_ícЫߢÄ1)^FޱfLõÒ„1™ÃÕ͘Ìn¹ScW;w“Ý©±qè!Àôñ;®Šßí^•2Y;›þ LÍÒøm–#¿l`/Ëkè0&¸í&{[4“Ð3€ ÜÎoÈI·c’Ф˜6SŠŒö6€a“1éÃ!…raü¦ç÷õõÌk,éëÄÌG“n0¹Þ,Í&ñ¾ºEþ}L„KÑn²;56=˜à9â7,ÛžØÈÖd'ýÿ6¿µKã·YR>œnƤ?Çc‚ÛˤÎîÍ8ô`r;¿MÒ—/¥H_úõc 6¦H^Yvý˜ìaLÀ…)åôEwëë™×X2ÿr)YoƪÁ²YšÍ.¤Ïµ'³[ö,®vî&»ScãÐC€é9â7,Šß)q Ö&”sáªù­Y¿Ítï’Ó͘¨«1ýøÙ¢‡L¾íI »àŸ’þ¿œvû˜bHÖ›I¬¤g~°V1&{8¶Q…¿è.p}= 5¦(›s0Mê—ÍÒŒ1aù´¤ÄÞEq„KÑn²;56=˜ž#~ÃòÀK(!X×M¨^ÖKÓ¹ò/ãü×ïÒ^ù`º§XÖÙ¢‡Lnç·þýšÍ„’“joØžè'i^L6hæe™²éÇôzÌï K˜Ïþ`Z¿Å:=ê$©¶rÍÒlvaÄ›1%x÷1yÀ”~üìNC¦çˆß°*~èN‰A_ÌT;X6K3?fÂÆÄ$¾%…þÞ~üìNÑŒC&Wü)ºSÒæ[dØÂëŒI±Ì8iPÜxù~˜ìZa~û| ˜–=¿ÑN 9(‡¬Yy³4aL‰>öÍÒÛÈ»ÎîÔØ8ô`zŽø «âwÔß šå–D©4¦firb’8Ê͘ÌNÈ& ?~ö¶h&¡gºâwцp¶Y{Æ÷6S²Éžv'%*AØìc²‡õß6¸ÑZ^¿L¸*~[GW ±”ŒµS³4aLvðbL6¸¯#~ã¥h7Ù‡žLøñWÅoLÅæIê»ÙœþÞ•«—&o3sÚº“vÄo¼í&»S4ãÐC€É¿cVžTô)v ½©1±„P¸PÄ͹rö°ÍñÕÝ â|Ôæ¿Óªø!£~JþR¨ú˜š¥I™¿òõ;à›ôéR´›ìNC¦çˆß¸ÚùÍò²­ ™ UŒ©YšMIÉ%ÜŒ)ag´âÕÎÝdwŠfz0¹â7ꆀ j¡Û¦n«]ÀÔºŒú3ÉLÉZ’7eŠðÒÜ•ªMª¦Eñ;G¥oæò§EQÏ.l–&Œ‰!ÞÅu—üêcò€‰üìNC¦çˆß¸*~§Èú–@LÖ-þ·hš¥Ù]9d¹“ úèÓ¥h7Ù¢‡Lñ»D3/ɯ­ÜcR¶a'Ì-»Œ‰”¨)’g»\¿y*‡Ëâ·¿Â)‹i •ø]/Mq¼ïÊ! …0ÝŠvÝ©±qè!ÀôñWÅïXDR2kh4¦ziÖ•›>¾dQ–½­Ü¥h7Ù¢‡L®í‰ÀôÕYìz“1Ùþ[y“l:XêÃ(ë^.†øÍ¹r××3¯1›S윖ê>¦fi˜ðž]hÛºDk¼Û¹ëìNC¦çˆß¸<ð@ŠÓBbu‰·Yšµ ~ÿˆÌ(>Qçæ7ÝS,ëìmÑLBÏ&rÄïÿý_fk³ %Ùí]KNøº-'Hvsy÷T1k;g%LßÜÊѲøb-¿lc<+ÆÔ,M$úÜ•Ë6»Ð&ºí:»ScãÐ3€‰ž#~Ó²ø`ámwÝÇÔ,M¶rXr¾4&ü*˜nE»ÎîÍ8ô`rmOJÑ­'ÅhgÐÊ$7Sκ SFÂb-Ü»}LÖî•‘CÑú§¤\_ϼƜũ„TªS¹fi˜´ nÆ­1¾Løãgwjlz0=Gü¦å—¨¥ŸKbÂRyå4K“¢ˆ·»Ø Ë0ÝS,ëìNÑŒC&×öÄ&'f;â1û“ÿë®\¶‘Õú×}£íÞ•+@¯gM2ù&0­v~cÌYÿXÖ‰ö˜š¥ cÒõ3" )EwÚ3ÒÕÎÝdwjlz0=Gü¦UñÛF—Ù¸¿’kÛÓzifIñ¾­úbLJ™z[¹KÑn²;E3=˜\Ûû, è[˜#n¬½ïʽ®ï ³5Jl2&}Xbˆv€Iù«–´*~ƒ$±açfªY]Ii–&/¿‹‰Ûï€KêÓ¥h7Ù‡LÏ¿iYüÖ7:¤™ê“vi6ŒÂÝÇC˜nE»ÎîÍ8ô`r;¿£þ„€‚óy¸•ÆdW[$ÉÜ  Ò˜Êkz“1jŽoڞЪø]€©Ø‘jÆZün–&rA¡—vÞoÇT§Æ.E»ÉîÔØ8ô`zŽøMË/ƒ @ÓßQˆµçw³4¹’’2Ý~L€]£x¾§XÖÙÛ¢™„žLìv~G°1ÝŠv•fî#YiL¦¡Ìú—MÏo}X!Ía ÂWOåxUüÆ’r],êÎïfiÒ+gW¯ßBé´ ð¥h7Ù‡žLüñ›—mOX¿ zÝÍú LÍÒäTN¹p¹qîÜ•ãÛˤÎîÍ8ô`ò;¿ö]ÎÉà€)¯v~‹ý‘2묮€©Y¿ü؆ ߌ‰ÞÃ/½»Ú¹›ìNCϦüñ;/Šß¶ibƒ[PÓüV-Í,)R¼ÿŒ¨?Ì^ÑÀŸÝ)šqè!ÀäŠß‰(cRèÝ ¼éùMö÷`ÓŸæ&”µç7¾—(ƒ ø¦Æ”—^Z:pQ¾[S³4±Ö¸ÆÐ¿d¼îËïžbYgwjlz0=GüΫⷠQ:bÃ[«a„ÍÒ„1½Zœ/ÆDÄš/E»ÉîÍ8ô`rÅïbžJC ”­K“‰"’‚šM—“°ë.ô[Leb²òM`ZíüÖ×J±‰Rºõ 5¦vibFˆ\àfLœ sí)_íÜMv§ÆÆ¡‡ÓsÄï¼*~³u˲‹nµµn³4³=ù0& ¥3%%_Šv“Ý)šqè!ÀäÛžDÓS³±È’h×Á’YHßß"F{¶û˜8ÇRâ Ôæ¨ö/À´<ð2ÚT…£”X¹ 4K“Ù…„áÓÇ$1öXù=ŲÎîÔØ8ô`zŽø—=¿õ%¡ïçT°Þ,ÍŒâ1…›1½.ŸúEsy×Ù¢‡L¾í ¢ÝÀÍhà ¤çÝù]r¶…òŠÛw債݇—ïçÜpå_€iUüŽæX«ûRÃU1¦fi2%Åä·›1I×ó+_Šv“Ý©±qè!Àôñ;¯¼´†›X¢$j^VK³Ñ:’îa„úÏO­\ùL±¬²·E3 =˜Šo{BÅ`D·´¸ãõöbLd£—˜á·À®ÆD…‘Y1u3øÍ))eYüNúRQ°ÕÖâw½4;`¸=¿L°Ã˜Ê­h×Ù‡žLå9âwY¶=IHFIô}‘«vfi6Wî}?îŘô7ÑÙÊ•ÛˤÎîÍ8ô`òmO’¾xC ¢Ú‘‰®ÎoŽï‰—/3´]Æ$º{„b„¯¶ ”Eñ;¶!·Ñøc©Xy³4écbÈŸiÏ6Ö³Scøãgwjlz0=Gü.«â7'ëwQF’S}%¥YšoÎñöʱ½·Ù¥h7Ù¢‡LþÀËWëšGuæí·»@†”J ÖT³í`)™äÕ[!&7}˜VÅoíž8%&ýᅩ©Yš¸¤*‡¼ï÷˜ìX:5v)ÚMv§ÆÆ¡‡ÓsÄï²Ñù]8„ôn‰üÛùýwi˜óí•CcçĤü¶sÿÍîÍ8ô`r;¿•«ã.uC…›“xÙÈŽRž$ÖÉ´ÛǤ;MN¯}Sü.«ßº©ë LµŽÙ,M.ñ"]ã¬ôEõSúñ³;56=˜ž#~—uÏo]àÀhçÛ‹¦Yš0&Lå3%Uÿ¡S4#ï*»S4ãÐC€ÉïüŽ)ç3)@ÑÜy»îcÊ IlW»Ô²ÛÇ”³þÓ“DAú.cZ¿ÅZ«ts«P-Mƒeµ4í•Ë_ù{.©¥üøÙ‡LϿ˪øm¦Ò‰‹]:MÕ]¹fi˜^ScoÆ”Ä?1QÈúñ³7E3 =˜¨ýê®_M(AY^ˆhwJJ21–Q¹âu µÇ˜ +$é.2ãÜeîÿ˜®¯g^c AÚ®zXãè_`j–&5Æ@áö•úT§Æn#ï:»ScãÐ#€‰ÂcÄïëóžM6 Ä\6BÄæo½4aL6ýýfLʉýv —¢ÝdwŠfz0¹ßô Ì`wKìÒÚî\9ó-£’LßöcJÖèªûÞ ¾y‰÷úzjLa¶0~ ï‹JXª¥q™ÕÔgv¡B¯ï.@üìNC¦Çˆß×ç=/¥ü)´Yª“fiò6Iwç7a½¢¹§XÖÙ¢‡Lnç7€’Öð2ß,óŒ1‰èŒmlզƤƒIæÂvÿÿ«ŒiÕö$*‰‹õG/ÍÀ‹zi\c6YnƤ,ºWcüãgwjlz0=Fü¾>ï…¢±!?Ö-B¢š1ÕK³æ·òq°¤Á?•S¢üãgwŠfz0¹ß€æB ’#É{ªÕcÒ¿*X£AJÊ9¾ŠlW¿0ÎQí_€i¹ó[ „Bú7ª<¿›¥É%^|~yO{Ž_y w;wÝ©±qè!Àôñûú¼ŠÆÖ`6ÃC®g~5K3ÆÄáîcÒ_FwÿŸüìNÑŒC&·óˆCÎ64=Š‚ÔcJ1•h»1B„½ñMöpŽ‘ ½îã,¯¯g¡Æ A‰ 3T“xš¥‰í ¾=Ð_Ø/L=`ºí&»ScãÐC€é1â÷õyÏ‹&“dQÑíU'&íÒLc’ÆÙ?•£øñ2©²·E3 =˜¢Ûù `›©bÛªB¸y*—l¶§ÝuK™i×ÁR†b§ß¢È‘¾ LqUüf›Ú£L.ALPS½4®1QܸÝ´ÞzrAŒ?~v§ÆÆ¡gS|ŽøWÅoÔ_ŽÍ.Ì)4íõÒ„1¥ü™’JÊü£\ÝäýøÙ¢‡Lnç·ý‰)ÝòGÁÍÎoÅ£bWxƒ]áŠ[[9{XbÒ¬~\æ¯ÿM`Z¶= A_ZlŒfûþ4¨þ˜–ÅïBfNe㤨j°l–f/îÅ¥^ÝŠvÝ©±qè!Àôñ;®Šßvm!êf]ßX5¿5KƤ?§_©gâ¥{›?{[4“Ð3€ ÜÎo…À±˜ÉÎÁÚëÞ|@3æú H¼úv–“>Ì&L—T \æEß&XîüNJfP¬,•øÝ,MlOBþu°±3TU«ïÇÏîÔØ8ô `‚çˆß°<ðÒ`Óëê~u”Û.MºrÍ@èfLˆk]‚{ŠeÝ)šqè!Àäv~G ¯Ù‰¬„ióTN©ˆr%1I…p˜ÞgÝô’ë}†°uþ`Z¿Q·´dW¼_0[]I©–&Œé:í}3&Ž­àŸÝ©±qè!Àôñ–=¿õ !ÉŒÅB-L6KÛS¸‹F u4&¸¼ëìNÑŒC&à¥!2¥’µÎË–µ®‘sí¤P>ãŠ–Šæý0æ`0˜VmORŒA¿½l Ãßk—&ŒéuJù®1僡ªú6øñ³;56=˜ž#~Ãjç7F2û›[«¹òÍÒì ߌɼˆ:Esµs7Ù¢‡LÏï"A2åv;¿£î‰8"“±¦MƤ e¥Zv‘wúð¿Óºí‰MLj`Gj•a³4aL€xט~¬Ôcå/“*»ScãÐC€é9â7,{~§$u{ ±TÀÔ,M“ÖÌÇéê÷Šæ6ò®³;E3=˜|ÏïˆEßÌÖ½¶Úìç”pædÇI`“1éÃ’rÉfO0¨þ˜VÅïbã·Y7ID¥bLÍÒ„1¡õ1]S„Δ‚òãgwjlz0=Gü†Uñ[7v´l6ÓµÆÔ,ÍÓ»EàŘl³î ^Šv“½-šIèÀ„nçw Y”@–d·°é.ØpØ€%DÚdLú0+ˆ68L÷ÿL¸ìù¦9­ 3 þÛ.P/MÅxßÇ|9Vujì6ò®³;56=˜ð9â7.‹ß”•ògA&cj–f£uRø0&3gîÍ­h×Ù¢‡L¾çwÝÈY³€µwm:Xšÿ¤Â°þRt8ׯkƤ—¢¸R-;dú&0-‹ß” ±ò^´ÑÀÅïzi˜ˆ“|÷šxñV´ëìNC¦çˆß¸*~C¡—Pš”ŒT}LÍÒ„1™·Ù͘Jéuåâ¥h7Ù¢‡Lnç·þ‰G%(ÛSö{“x#”ƒnǤ\ûÀ-ÆT¢Y1Ú‡6Ýþ 0­Šß‹ÝW"ÝLâ­–&Œ‰ãÕ.`ŒIz—xñR´›ìNC¦çˆß¸*~Ç IãíÐ ê¹rõÒ„1ÙLëëmÆ!ôîÊá¥h7Ù¢‡Lnçw.Eß¿Í1ïMⵜ¢™]L‘ÓV¤Š1éÃvhGLøUñW;¿ËkH^¶#J®,š¥éø¦ßÙ…PØF@xµs7Ù‡LÏ¿q¹ól02Š~%¯€ÿnåê¥)cJ?¦Ñ7Š'¼Û¹ëìNÑŒC&·ó;K‰ÁF›'‡MÆ„Ê”ì ®›1Ê[[¹÷Ã,úi!²|˜ÖmO ç`Þ ™©Yšy~‡x³rýûuæÊ~¼LªìNC¦çˆß¸Üù]lêRÑo<@Ýù]/MS&¾=¿9†ÒaLt·s×ÙÛ¢™„žLäv~gάۃ`c¬äåԱØtC!Jštó 6Ýx1‘¢„’… •ôE`¢UñÛº!aÉ•çw³4aL%}:¿‘¡gßL—¢Ýdwjlz0=Gü¦Uñ8@6'öT1¦fi2ÁB)Í=%Åü“;=&t)ÚMv§hÆ¡‡“ßù˜0Ži«ÁÒH’ÄLÂÎwÝèeê‹Ìf{öÍvZ¿•÷Q2¢`}» ^š8X„ÛŒPw=¿©üøÙ‡LÏ¿iUü6š£$ÛTES/MÄ|» 0½ È)?~ö¶h&¡gûß’ÍÁcÛñlw~³2-»Î"9DžÞí“]+4÷J²+1ß¼ÄËËߺQ²îE݇U/¿viâùßnI/Æ”ˆ:מøn箳;56=˜ø9â7/Šß©˜3u v„DUWn³4cLÌƤUÛi°døñ³;E3=˜üÎo&ž Û8LÛŒI ä­ sÚ²=y=ƒm£":}˜–=¿e±æXk†ÿ[cÍÒ„1aÈ)瞃ßFÞuv§ÆÆ¡‡ÓsÄo^¿ 0‚Ƨk£¸fi˜ìRÛGcÂ^ç7_Šv“Ý)šqè!Àä{~‰…mŒ–AôÖ•k# ƒ˜àO@[ –ï‡9²K)oÕ¯Ójç7™©%ÖÍ~uW®Yš0&;J¸SæÐ¦«»ÉîÔØ8ô`zŽøÍËß å ºå°»UÕV®^šMI•ßÎoaèœÊñÝÎ]gwŠfz0ùžßáu¡oaÓ™¶SHúyR)º3ÛeLú1¶Ëz1|Õ‰—;¿ƒ50fD¥‘µ¯|½4cL…?S.½v¾Û¹ëìNC¦çˆß¼,~G›ÚJ©@¨Fë´KÆD>ç^W.ߊvÝ)šqè!Àäv~—lÝv ÉöŸ{}LBd®%)ÉiÚ#Y3&Ýdzõ@B}SüæeÛ“È™P?Ý]ÖÀT/ͦ=Ç—ÓÛWc•ß^&uv§ÆÆ¡‡ÓsÄo^îüŽ’ì¾)§LQ\µ4cL1|cfËÝÎ]go‹fz0‰Ûù]ŠM³Î@¹SÙº’b¤Gì~éÆ5½G„o1&Á¨Ú÷1ø€IVÅo“ð)ä‚êI<ÍÒlÚóÛ_ò=‰S¯Æ.E»ÉîÔØ8ô `’çˆß²Úù¸-dó`ƒÊZ·Yš1&ý%|“Ý\õ‹æjçn²;E3=˜|Ïï vö ˜(ÛÐMIÙ–nÅúçq·IŠ]÷ )ê†ú›À´*~Gk·#¯PÊ_VÞ.Í&ñЯ¯<$é0&¹í&»ScãÐC€é9â·,Ûž‚íb.éoó[»4aLœà>1aI=?f¹½LêìNÑŒC&ßó;¤Rl²\,e×ÁR(‰Â™>yo+÷~¸˜Ñ›¿Á75&Y¶=ÑrŒØÎú+ñ»YšÍ.$ú0&ê\{’ÛˤÎîÔØ8ô`zŽø-«â·ûA²!$Uçw³4aLŠFÆd…¢¹í&»S4ãÐC€©ãùmãQ¨°¼ìNI1Ï0Û±ßÊ.cÒ}´îåŠ ~‹ß<•“Uñ[ù{„Áf¶U[¹fi6íâGc‚Üs°”KÑn²;56=˜ž#~˪øMY¬Ÿ9g©:¿›¥ cÒ×ôíÇÌ©ôü˜äR´›ìNÑŒC¦Žç·þlR T0¤½áFz’BÒ‹ؽ+§g³ˆeA»ÁóE`Z¿1¢5¢EB¨Åïzi˜2Âí`¡¯¾^¯ÜŠvÝ©±qè!Àôñ[–=¿‹aˆ¾¡¥To³vi˜Ò{¾Ä‹1雭ØÒmä]go‹fz0¥Nç·þa•¶$¼±3L÷͘"%É<¶ÝÄÆ‚R!¥Nßx™–;¿m*`yÍW¨­u›¥c’|÷1ÙaHçå—îvî:»ScãÐ3€)=GüN«â7Ú=Ó¨ÿ»@³4aLE>~Lf&Ô+šKÑn²;E3=˜zß1ëVO‘iëï‹ô›oФƒ]Ïo}8å¤ÜR¬ê›À´*~³MÉË@™sªâê¥Ù´g þ0¦B>¦t)ÚMv§ÆÆ¡‡ÓsÄï´(~›D Æýí¿ëÑ:õÒømfV®·“¹Êvî1%úñ³;E3=˜üÎoëÓ³ÙlÛ¶¶rFz”h1+ÎÛöuw¯5NY÷· Ìį2¦Uñ»XOU´sÆJün–fÓž Ê͘(BGüN—¢Ýdwjlz0=GüNËâ7A¶‹úŽ®‡6K3ÆTâ­1I ž»`ºí:»S4ãÐC€ÉïüŽ!êfLéЮƔtÿ—Õaò|7V1&}X·$Їº…üªƒeZx™³éñ,‚µ»@³4ñü2Gó›1)©ì8X¤{ŠeÝ©±qè!Àôñ;-w~+}µy’9 ×íõÒDc*ésó[®œW4w;wÝ)šqè!Àäv~ÇRâbçÏ{â÷û‚„]ÂÑ™ä¸ÛǤs"ÖŸX‚ožÊ¥eÏo°2Ök ¡òcj–&Œ rühLÒ’’n#ï:»ScãÐC€é9âwZ¿ƒd¶ï"Ñû€ÿ»`µ4~›±þ˜ðØrê4Xæðãgo‹fz0e·ó[ SÔ?lˆYØdLY1‰B±~?à]Iq+¿Ú¹›ìNC¦çˆßyQüNúVµKhÔã››¥É©œnßn‰—Þþ?ÿøÙ¢‡L~ç·’¥`3„_S·€É dc²6䤿=Üu°‡EÐ,0¥iÛø¿Ó²øMÅ®@0å­¿ë¥ÙìB)÷©œY»t®¤ä[Ñ®³;56=˜ž#~çUñÛ¬9ÌìA÷¡&ë¥cÂ_)…Þøæ~üìmÑLBϦâw~“ '´’—-ñ[IOTîIIÌGÖî†í1&»›WlJMˆå«¶'eÝóDÌmY_WÕ•”fi˜²¾ýîSèï0¦ò1ò®²;56=˜ÊsÄï²*~S  €1êW^Yë6K3ÆÄù>1Q`ê]°,—¢ÝdwŠfz0ùßb7iìjH,›ã›Œô MJIq³É»a‘CHó+ÿL«â·¾Xt_  –Š15K³Ù…!}4&ì°òr)ÚMv§ÆÆ¡‡ÓsÄï²j{B6ÏT Ù¬ÛPS½4ëüühL9ÇŽø]èÇÏîÍ8ô`ò;¿QêÙ&–mΕƒ©¥«ÿU6ïÊéÃŒh3Lô‡ ß´=)«ß©€ng‹Y±Uמڥcúç—bo§Á²\íÜMv§ÆÆ¡‡ÓsÄï²(~vAÁz…1þm~k—æ}Lw{¶§å­h·Ù¢‡L~çwŽÅFŲ¤ü¢´Ã˜a›I,›Œ)°%ÝÏá¼;ó_€iUüNvr‘!0Sõòk—&Œ) |Xyèv~—KÑn²;56=˜ž#~—ÕÎo¡‹n8Ìî¡:•k–&Œ C¼Ý%ŠtŽrËÕÎÝdwŠfz0ù߬5Fßïh.»»Œ ’Ù½eÐýÜ®ƒ¥=\¬c\\‰Ó7iÙö„™ƒRhFnîÊÕK³S¹w]½ú˜J깤–ÛˤÎîÔØ8ô`zŽø]–Åï¤Ü5"R©çʵKƄŸÎoô·rúžûñ³7E3 =˜¸ýêâuh_€ìpio|“‘ž\R~™¢•»SÐýH õëù àÿ`º¾žy%}©Q»$Sµ 4K³S¹‚Ÿ“_ý^]Šv“Ý©±qèÀÄá1â÷õyÏ‹&Ký™XÍPu~7K3ÆŸ?£DFÿĄåh7Ù¢‡Lnç7yé<º‘Sδ9W‚°ëçÎ%5cJRìè;Û §/¶ \_ϼÆRb}O™‹5V[¹zi˜ ”Ï©\Œ¹Wcw;wÝ©±qè!Àôñûú¼Š&g}=çdT˜4KƤ¿ÃûÄD Kïmv·s×Ù¢‡Lnç·ãF"›Ïˆw“ºb‹¼þâóyõ©œÍg§Ô }Qü¾¾ž•³;º}sÕSRê¥ÉÉo ñ3íCç>&‡ÛÈ»ÎîÔØ8ô`zŒø}}Þó¢Él½eÉîea5W¾]škLp3¦PÄïcâpµs7Ù¢‡Lnç·ÍšÆh×¹BÈ»žßŠ-`jJ¶q—2Å–º‰!é¿Ë«óë«[¹Uñ[iHI±d¦Xß•k–fÓžInÏ/FìôÊ)Qýñ³;56=˜#~_Ÿ÷¼hrH&°¢Xª­u›¥™ÆDøñcŠ}?&—¢ÝdwŠfz0¹ß¶/h71ÊÞ%^E5å[)ôvÄØ&Ó™¹ÀWÓªøQ? â¬`[7X6KƤ{úÏÉ/•ØcL—¢Ýdwjlz0=Fü¾>ï…¢É6‘ÑÞêÐnåê¥ c¢ÈÆ úíß½-šIèÀÝÎoE±Ž¢ J]h·ó ƒƒ^Ó0½Î9[Ï—¡Ó)®ŠßœèžV÷–…+`j–&Œ ï+)6»Kçå/E»ÉîÔØ8ô `ŠÏ¿ãªøm“‘J)6S²FØ.Í|¼r$ôæÊéNþÇÏîÍ8ô`r;¿”¬‘‰³Ø…·] R!³.‹!oΕ³óШ»ëǧrüvçòjìn箳;56=˜ž#~Çeñ;gëT#Ô½×ß“viƘ’ÜsåDq¤ÓcoE»ÎîÍ8ô`ò;¿m‚ÒËØ`bs®œîÆ0Aʹ ìö1éÃJ]mcRä›WR®¯g^cɆ•ëæT?7§þ¯ÆT/ͦ=Cþ0&!êÉ·—IÝ©±qè!Àôñ;®v~K ‰ +©Yš3¦ƒ¥þ&;}Lpµs7ÙÛ¢™„žLàv~Çd]ßP Û “mwÂúA0‚­ñM¯‡íLTÞÎg_´Ö½¾ž…‹DÊv_—d©zù5KÆtMFy3¦Œ .#ï&»ScãÐ3€ ž#~ÆíIƘYì†ULõÒŒ1ÙDê»)÷üz™üÍîÍ8ô`ò=¿Í°À.Óòþ]9 P>‰¢dØu°Ô‡•i)Y³=û&0­Šß"æBª$S¨S³4aLå3í9ÅžŽ —¢Ýdwjlz0=Gü†åÎïD’ô÷Ü ­Ó,Í“„Ï©\Dî½Íîvî:»S4ãÐC€ÉïüQ¸©P fd¹{*—¼Å뢿˜ÝS¹””ab&ëýþfƒ%,w~sÈ $ýCqÝ’R/M“þÝÂ͘rн—ßÝÎ]gwjlz0=Gü†Uñ»`Á,æús5W®Yš0&»Ðv¿Í¬¯°S4—¢ÝdwŠfz0ùßÁoh“”¶“ªB¶Ö­œ·.ñ¾æÀ(9eÀ¯^IeÏïhÖIœˆˆëS¹ziƘ~§=›A¨oÇpy×Ù‡LÏ¿aYüÝS§È95s媥 câx]0Æôn„óŠæV´ëìNÑŒC&¿ó;`*Ñ.^ÅÄyKü~ÉD¤›WPx‰ ·JÉ Di“î}˜VÅo%¼ú1Ä@©²=i–fŒé×Á‚s K¸í&»ScãÐC€é9â7¬Šß"ZÉÅ•©:1i—fÓ¯» „:o3¼í&{[4“Ð3€ ÝÎoCd3³™[㛬‰ XÏZƒå®ÆmBŠˆ"9¦¯nåpYüæô:½ ·Õ}Ìfi˜Àï$ìLâe¼í:»ScãÐ3€ Ÿ#~ãªø­/vA³§%Ww嚥™ÆñwoWcÂKÑn²;E3=˜|Ïïbžßôšê!qs/¼†£ Ò Xv;¿mªÚeýá7,qUü.dv¿¢|$¦ª©YšúÊÿNIÉ©wQñÇÏîÔØ8ô`zŽø«ß° Y¥õ%Þziæ.äÓcRt¶rxµs7Ù¢‡LÎoÒ]A c(/K¥-éuy7+?`áí>¦Èúñ‹þnS†o^IÁUñ›YÿžC„z|S½4ó•Gøu°è #`ä?»ScãÐC€é9â7®ŠßB b=yhRÈß­\½4»+‡¿^9%ô®  üøÙ¢‡L~çw YIO&(y›1‘‘D)fÍK[WR^SHÙîWdàoŠß¸Üù@ívëkwfi˜ŠBõ§ÆbÏÁïvî:»ScãÐC€é9â7®¼Ì’³ˆäUíÍÒÔ]àãùÍúƒì½Í>S,«ìNÑŒC&·óÛÎÕRF›-§«0\¤ý»ŒIb~u ;Úû&0­Šßl3”^–œ_~íÒtvaùœÊ•Dvºí&»ScãÐC€é9â7­‹ßJCôG@ÖY‹ßÕÒìTñ3%µt»ré£hWÙ¢‡LÎïlG£ ¥Ö{µÕ.ð"=¥ ™p€ÔÛeLÙzÍ3*ÒW5&Zx©ä1$ÎëaõÒŒ1•ü¹{5vO±¬³;56=˜ž#~Ó²ø­_GŒæô¯¿¤Jü®—fŒ ?FÎÔk [Ñ®³;E3=˜ÜÎo;cIlZQÜ÷ük`³8ç½v×à Kmhf*ßœ’B«â7ë×WäßPò_ÆT/Í}<¿tŸÜ¦KÑn²;56=˜ž#~ÓjçwŠ…bH!Ù4¿ÀÔ,M§¤0ÿ‡1uNåèjçn²;E3=˜ÜÎïÈæª R²é[WRŒô˜s‰BZV¶5¿‡[3&4s¡\‚ Ìü*0-Šßf‰œS0/—R_{j–f§r3•®ŽY~üìNC¦çˆß´l{"œ9HfÝ:T“x›¥Ù©\þø1qy›G8E÷—I½-šIèÀÄ~ç·õ©cVޯƘÝ>&b`ý$¶çw$(Q"ÂWçÊñòÀKå~6+ U/¿viƘBþÜ•ËÝkO|O±¬³;56=˜ø9â7¯{~kÙ¼¶ëëÍÒ”1å_‰{Íoü1ò®²;E3=˜ÜÎïœJL6¾ ß#:_¨Ë˜0R¢hg¥N»}Lú°̬ï~™Xù`Z¿QßY%)•Kj»4©±ò[c9uú˜øR´›ìNC¦çˆß¼*~[ÿ†©" •øÝ,MÞfLtŸ˜ˆþ;_Šv“Ý)šqè!Àäv~+¨DBL1—D²LFzŠ`ŒvF„”·S±+… J2“|óTŽÅoÝQJ†d.Kµ•k–&wåŠü2¦”{'¿Ì?~v§ÆÆ¡‡ÓsÄo^¿‘ô'DºaªÝš¥czßý¿Í¤wÁ’åÇÏîÍ8ô`r;¿‚Ïv6‡¸Ë˜ ÙÍ-%Šû“xõaº4‡ýoÓªø]Ì%!ÚH‰Ê] Yš1¦{ÕX‘0]Šv“Ý©±qè!Àôñ›WÅo䌡(õOUƒe³4;•+øéüÎ{Ó¥h7Ù¢‡Lnç·]ÏI‘#“m¨l7FŒ‰lZ‡½Ã#Þj°|=lî6óJô]ñM`Z¶=1û5ý ed©N嚥IÙmÛ_R§Æn/“:»ScãÐC€é9â7¯ŠßA‚¡ù>`=Œ ^šjLtû1q =aRŸ½-šIèÀ$®ø­DÇÔakŽa|ñ–e`RÒ£HŒ!•ô¿q—1éú•³Á~6Ñ÷‹À$«â·uM”h'X»¤6K“ƒ ¿ß…z5v)ÚMv§ÆÆ¡g“w™û`Z¿ív £]s \Ê5K³ƒô¹+!wXäR´›ìNC¦çˆß²*~+7°SéŒR›xÕK³»r!æÊ+3îlåäR´›ìNÑŒC&ßöDëÿ„Ì!à¦Æ$²î‰­…×ó[õãJ¨üò»À´ÚùMÊy¥pŽ6´í/05K³+ŸS9‰%t¶rrµs7Ù‡LÏ¿eYü%¡î¼(gü{ó»]š½ÍÞS+.wÁØ™`!·¢]gwŠfz0ùâ7*QR–Glà÷&cJQJÑïìHo×)ÅdƒJ}ø«À´*~#Ú`a$ó¾«ÛꥩçWü]HܦKÑn²;56=˜ž#~˲ç7D‘¬¯ßÜ.ÍÞfî))œ t:¿å6ò®³;E3=˜|ñ›õ7¤{OÆ(nmå”ô$Q\ɯÍ`žß*©SŒ„3`ˆS_Þ¦ÕÎoýÚô‡/AÁ¶Ô½rõÒ¬Æ~gÆÜ¦òãgwjlz0=Gü–UñÛŽ!2(é «¹rÍÒìÄéÓùmçº~ѤKÑn²·E3 =˜’k{¦.sd‚Hi—1)EBÖ¿w€ydŘôa(Xlg"ñ›§riUü6_)J%Zsu%~7K³^9øí•ƒÜ›+—.E»ÉîÔØ8ô `JϿӺøý2ˆŒfYS½4;1¡_wÑÿNÑ|í*»S4ãÐC€Éµ=‘!¡èe­»Ã˜Ì.\8I&ý×î”}X½,§r¡`o+wy×Ù‡LϿӪø­/Xf*ún~åÿÝÊÕK3Æ$ñ?SÏö$]Šv“Ý)šqè!ÀäÚž”`?!4G`âöÓë¸ß®á$ýã–øý~XôóJº\ [ÿLËžß9åqc¨/ñ6KS_ùrÿÄœp:5vy×Ù‡LϿӪøáeêYÞ×nÿ»•«—fŒ ?~Ìl½Ç~ÑäKÑn²·E3 =˜²ßù­œ§³HÌ [â÷ÿþ£9ãÓËS¡ìz~£Í¹Œº…´öÿðÍ»ryÙöRÒeRæ[‹ßÍÒìvAÂOç÷uÀ«±ÛˤÎîÔØ8ô `ÊÏ¿óòÀKB €¾bŘš¥ÙÍï co+—ï)–uv§hÆ¡‡“o{¢Ÿ…MOÀhnåa“1é¦8êÇ^–ỌI†Œ)"Ãtø/À´ìùm·Ð2ÓËÂü/05K³S¹H¿ßY:S¾¼ëìNC¦çˆßyUü¢Œ•ËF®ú˜š¥™3^#­Žz=&™~üìNÑŒC&·ó;S2'„Ö³¾É˜¬Å€íú–²Øþ~8's‰ÅÈù›§ryUüÎÅÆ’¹W“xÚ¥©ƒEüícÂ^ƒe¾í&»ScãÐC€é9âw^¿õµ(2»ÁXmåê¥c‚ôaLн’’/E»ÉîÍ8ô`r;¿íî•ÝdNv½É˜0˜½yŽ6Ðx×]À›˜ Q÷¿ßl°Ì«â·þUtoj‡¶¹¦ziƘ ÿö1QéˆßùR´›ìNC¦çˆßyUüÈ¢ï ²·{Řš¥Ù\ùÀŸ»r¡t÷ÿ—¢ÝdwŠfz0¹ßB’Ds‘¶‰Ý»ŒÉŒ§tg·Y⦻€=l³ìX @Êßl°Ì«âwfL’„ˆXm嚥 câ·DpiLݗߥh7Ù‡LÏ¿óªøm—ÚBIvÆB•»@³4aLÊlî?#›y²_4åR´›ìmÑLBϦâw~ë»×ná’ݧλ§r@bV¯º¯Ðß.cÒ‡õ«àÉZ¿¾LeUü¶ h’)ùÕúviv*Ÿ))°×ù].E»ÉîÔØ8ô `*Ͽ˲øêW\Ì_¬ÚÊ5K³ ú;º÷ŠæV´ëìNÑŒC&·ó9ÖÍ-™õ÷¶Æd÷ÜsAw.SÒÓhLE÷$ÉÔ’Ìß<•+‹â·Mj ŠÎºK R½üš¥Y•_—Ô>0áŸÝ©±qè!Àôñ»¬Šß¤Û…¤{k ï9ºÿ’R/M}ÜtÇÞ±Ö-—¢ÝdwŠfz0¹ßÑZ‰Jf¥xQÿ»Œ)›«» Ê)lÓûá#é ä¯Ž/«âw1ôd6ð©ÔÖºõÒŒ1a¾§=Kè^{*—¢Ýdwjlz0=Gü.ËßÙ¬ûr‘Xw~×KÆ”˜ï‘: –ån箳;E3=˜ü—º—ÍŠ-ÖâÈNådƒ1¡Í8QFR%ïžÊéÃö‰™Ë˜VÅo*v픑@ÕÄÛ.ÍNå„~'ñRìÅ•KÑn²;56=˜ž#~—UñÛœ·tŸ$)2UŒ©Yš0¦Tàs*HzEs)ÚMv§hÆ¡‡“+~G1 & bA;<ÚdLB„ oo’<ÝÕŒÉÆ>eL¯‰Dßìü.ËžßZ Aû‰ë­\»4óc’üëù Øéc*·‘wÝ©±qè!Àôñ»,¼,„Hú ’”*ÏïfiƘrøeLýÎo ÷Ë:{S4³Ð#€IگΊµÌ£ÍR²nåmI’"·ŸÂ®Æ¤?Þ’0…Tø‹§r××3¯±d&ž)Ø-˜«»rÍÒÜ%õ£1ebÿå§óãgwjlz0IxŒø}}Þó¢ÉA¬0‘¾ÖëK¼ÍÒŒ1q¾•Òñc–?~v§hÆ¡‡“+~i}ƒMÃãdþù›ŒÉî³€èë%ǰéù­g;ÔdùâÀËëëY©1ŒúV))—Š•7KÓ»rrŸÊÙPUŸ1I¸í&»ScãÐC€é1â÷õy/Mä˜tg]lœdm{R/M§Oç·M\ôÛô÷òãgwŠfz0¹â·þ‰™ˆcSìw;¿‘²Ij’À0½.Q¹–îcúf»ÀõõÌk,)Ibc1Åú®\½4ëc"¹kLBîôÊé6úÇÏîÔØ8ô`zŒø}}Þó¢É”‰èË"êë§:Êm–&Œ‰ðãÇDBèOI‘ ?~v§hÆ¡‡“+~›¥}&»Llîô&c¢PÌ*Nái÷ïûáb'sJ»bùb»ÀõõÌk,@ÅédÃ?+ñ»^š0&‘_w¹Wc·¢]gwjlz0=Fü¾>ïyÑèÖÚ\û„CëÇÜ,MJ¹ý˜Èúû:EsO±¬³;E3=˜\ÛaS³°Îï¸é`‰™ô¯Œº«(sýºéü67,Î ¢þÚ¾ L«žßÄ ElÐ;@å’Ú,ÍNåtÿöaL¡ÓÇ$á2òn²;56=˜#~_Ÿ÷JÑÔÊñeTúGü®–&ŒIäöc"Lá?Šv•½-šIèÀ]Û…&,€ ïà½K»îöj·°9$·ý˜ÐN’9—òÍ))××3¯±ÄÖPúõÁÛMé¿îõÒŒ1½ÇQ^SRrGcŠ—¢Ýdwjlz0ÅçˆßqÙó› Û¡W¦\[ë6KÆ ßî‚dƒà;Esy×Ù¢‡L®í‰ù0…×ýw›ð²Õ`i¤§èS¦yØpômw;FçA?¬üMÆ×mOPíf{ÀµQ\³4Ó˜ÒSêØžèçþãgwjlz0=GüŽ«âwŠb=ú^\S³4cL,¿Œ ¡Ç˜.E»ÉîÍ8ô`rmO$Ý”d×&BÚíü6˽ú;aÅ´ëÇ„9)ÛB»fñM`Z¿sŠÑÊCR¨ZRš¥y^5ƦáujŒüìNC¦çˆßqÙö$ÍX’îÄêI¼õÒ„1¥57cîÅK¼½LêìNÑŒC&ßöĆ ™t)Êî©\,š6ë.NwdóƒµÚÁR7p/Ÿ8¶o¶ ÄUñ[BÎAw–9g®ÄïfiƘB¾Oå¸dì±òKÑn²;56=˜ž#~ÇåÎoJ`c[“ –þ LÍÒ„1Ù&ýfLÖ±Ö)š»»ÎîÍ8ô`r;¿í$Q²b5¥N¼Ë˜@ŠP–\8åÝ>¦)bHú dù¢ƒåõõÌk,!)LG°«Ú] Yšº ”Ï}ÌœK˜®vî&»ScãÐC€é9âw\¿±°~#…)ÖîõÒŒ1ýö˜„Î\yðãgo‹fz0Ûùm{8ÀŠ¢ív~¿|k +:I˜ë×cz䀀ߴֽ¾ž…Ó¿ ”ruÀÒ,Íf Á͘Rèø1 Ä?»ScãÐ3€ ž#~êøm®Av_‚Ýœ¨öÿÕÒøm†6•ãfLAß×¢?»S4ãÐC€ÉíüΊ ÌJ^‚R¦í»r ñõTdz?¼5%…„tGÂBsåü_€iYüÁü8#êN©bLÍÒTcŠŸ»r©$ß]@àV´ëìNC¦çˆß°ìù­ïUŠdRm LÍÒøm†J­?}LzÍopy×Ù¢‡Lnçw2ÛÍ’…m6€lÏ•SÂEæ$¬ÛcÙœ’b³u”lÌߦõÎï¢yy©.Š·K3Æ”ùsW.éÈði箲;56=˜ž#~êøMv£:£0‡Úó»Yš0¦$ù¾Ç„ºýïÑìKÑn²;E3=˜ÜÎïD6D‰‰­k}w/Vd²iÕD›ŒÉNh]T/ªùM`Z¿™ísÈAÿTcª—&Œ RŒ7c»„èר¥h7Ù‡LÏ¿aQüNæeâË¿¯>1i–&Œ)q¹Ý”=afç?»S4ãÐC€ÉíüV`æl¦ß±ìÞ•ƒ‚Ì?…{íï‡Ñ <”nQü*0-Ûž$3ˆ´­%U¾òíÒÌ] ~tLNÐkIÛˤÎîÔØ8ô`zŽø «â· q±’UI³4aL|Ûž(HIé^Šv“½-šIèÀ„~çwA$E¢5Ynö1é_–’™1…b£N6S6ÅEIá›À„«ß”Ü€`Ò~e{Ò,ͦ=—tÿ÷¥s%¯vî&»ScãÐ3€ Ÿ#~ãªømŽ"ÁöIªëíÒ„1I÷‰‰~¿½¼í&»S4ãÐC€Éíüæ”Í%î¥GÞjPÒ#ú›cK¹ lÞ•³‡uÅL?á‹–×׳PcÑ.’ÂtæR°ÔK3_ùÈÆ©3WNð6ò®³;56=˜ž#~ã²ç·9׆ÌÒº 4KÆ$oèŘH: –xy×Ù¢‡Lnç·yÛQ* ¤¡PÚ [£¦`‚í¹rö0£íH‚9Å}˜–^FsÕä—…ye{Ò,ÍfføhLˆ¥÷ò»§XÖÙ‡LÏ¿qQü6“ÃíÎm‘TÅ×KƤ?£ûÄ¥_4òãgwŠfz0¹ßH¤Ÿ†Ràÿƒ1Y£@* ŸbÜÚʽNÑìœôYov~ã¢øƒ]+FÓB͘š¥Ù´ç÷…‘c"èµ `úñ³;56=˜ž#~ãjçw“1¢]Åjàe³4aLæ~{3&-šŽ0‰W;w“Ý)šqè!Àä{~'Iv‘W÷TJ^6,AwÌ6%œô¿vÓk¬“ T¿èù}}=óKœ_'ŒÊåþžü¶KÉZO?Œ‰C¯Æ.E»ÉîÔØ8ô`zŽø‹â·õ¼€µFÎ\» ÖKÆô?&$îÅQøñ³·E3 =˜Èíü¶ Š ¬%FëݳþkÚ`LœXb úìÊÌÊŠ1±ýÈôÃCж·þ0ѲçwQ µYHUKJ»4cLÀƤûÕN»ÝFÞuv§ÆÆ¡g=Gü¦eÛ´¹P”þ×#›¥ cŠEî?#*Žt<¿éö2©³;E3=˜\ñ[!%bɺ E»ºË˜¸Ø¼u2£—²é.,60ŠQj¾ÙùM«ßh‡1(9% XÚ¥c¢ôéüÆÜ»öDW;w“Ý©±qè!Àôñ›VÅoÌ"Y_Ë¢_J}W®^š0&ݾ|PÏó›.E»ÉîÍ8ô`rÅo4ï‘tª{²MI7öt …·MƤ—J°VÁôM£8Z¿9)÷Sª“á]!Œâª¥É©\Vžv3&¥9‰øÇÏîÔØ8ô`zŽøM«ßÊaìÛH+ÛÓfiƘlö͘‚ôhöÕÎÝdwŠfz0¹â7±Mw³©¸ívÎcR©ÐdƒÞyÓ(îý°˜Ù'dø*0­v~Ûfb¶)ï¥n°¬—&§ròßI<Üëü¦«»ÉîÔØ8ô`zŽøM«â·}„üšBZm嚥câÏ”TsìmåòŸÝ)šqè!ÀäŠß6y)0J‚œÍa1a°9™1Ú$޸˘Ð6r6‡Wàíù5`Z¿•þe}Qå¢ÿQÝ•k–&ŒI$Ü–T¨7».E»ÉîÔØ8ô`zŽøMËâ·]\()Bh¦¤6KƤ¯œcŠÐ»`É·¢]go‹fz0±o{˜P¡º˜å"m3¦ÀúKI6¹Rw‚»ŒÉfäÝæØÅ–o6Xòªø-v–föIL 0ÕK³Ù…îß•®ƒÇ?»ScãÐ3€‰Ÿ#~óªø­LZÿ6½½2Šk–Æo3(œîý?†@S9¾í&»S4ãÐC€É·=‘”3€nˆ(m‰ßJz@?=bûb]Ƥ“ %!ÊüÍK^¿(ŠIú!Öâw½4›]Ÿû˜”JO.à[Ñ®³;56=˜ž#~ó²íI2éÆ^Ρ6Šk–fŒ) ߌ)¼)·W4·—IÝ)šqè!ÀäڞĠ¥®¯`ÝS~‘žN5¸Œ)‚2-TXÚ´=y?ÌJØDÿ#§o¶ ðrç·’@s½ãjo»4›]xmëbçTŽïvî:»ScãÐC€é9â7¯¼4Ìù*©Yš1&ü¸ ê{­'LògŠe•Ý)šqè!ÀäÚžDkûe.Š0ür.Y&ýô"Q´qt@Òn“>Œ¨Ô¡Â7,yyàePÂk³‘HéÈ_`j–&Œ‰nVN)ÆÎÉ/ßS,ëìNC¦çˆß¼*~›!nÎ6-P5%¥Y¿Íôýürä¶?£MøèÜüæKÑn²;E3=˜\Û“h­Ûu§ðôj°ÜaLÆx¡HÔÅ‚LT1&{+!é?:Øœ”oÓªø£IŽ˜•þ¥Ê] Yš0&Ç|3&æÔ9`áòãgwjlz0=GüæUÛÝ/D»“¥oŒ\Ùž4KÆ”Cú0¦ŒÜaLry™4ÙÛ¢™„žLâÚžDe-6t*IMÆ‹Ý[.ÖpPbÚÔ˜ìa P²ÝÆojL²ìùm}¦ d¨ä‚fi6»0ýjLú·ìœÊÉmä]gwjlz0ÉsÄoY¿9+uMí}ñwÿß.MSJxû1ÖO‡1É¥h7Ù¢‡L~ç÷ë&WA›Ið¾î¶Á˜lzSÒM )¾—]Æd+"YU‘ù}–¦UñÛ&¾è‚(fVŒ©YšÍ.”ŽI˜¡sÀ"—¢Ýdwjlz0=Gü–eÛ“ ¿ÈQb¨5¦fi˜RÌñfLŠQ=`º½LêìNÑŒC&·ó;ê¶€™M·Sû]ÆD@€%G›žßö0 Ø ¾HòÍvY¿Eÿ%)ŽÐÛAé¿íõÒŒ1½ïÇ]Óž©sÀ"—¢Ýdwjlz0=Gü–Uñ»˜ç=²¾×…«vfi˜lúì͘¤pf_Šv“Ý)šqè!Àäv~+0•B²‡wƒåc2ÿ¬û@SÏ7“>œ“š[ÜWiyà%!ÙµâRb%´K³I<÷µ§×¶.öä‚{ŠeÝ©±qè!Àôñ[VÅïÀ’^Ç]@µÆÔ,ÍÓïÍocL£\É?~v§hÆ¡‡SÏöÄú¶CÐM¨{î1&kO¡ØUœ8·Tª“>l#ײâšù˜–;¿)…iÊúÛ‡˜ª¥ÉíÝh}4¦˜z,r·s×Ù‡LÏ¿eÙó›(辚J¬S³4cL¿såô—Nçwº¼ëìmÑLBϦäÛžd,fŠXB’Í>¦hº™Ú_LúØdLF,A [,úÏÿf»@Zíüf¥}Aÿ*6¸­¾Ä[/MS–øéü˜;/¿tµs7Ù‡žLé9âwZ¿ÍósÖ(\u~·KÆ$ò˘lÃÞ)øñ³;E3=˜ÜÎo¥K¦ð°nB…¶S Ì´Ø]à­áï‡Á†”H)˜–Åï`YÀC©]Rë¥c»EÝàwjìV´ëìNC¦çˆßiYü.üºR(•Zü®—&Œ‰24&ýßa2ÝŠvÝ)šqè!Àäv~ƒmŠ6Ô&–ÅMÆ$œm ²Újx?Œ6!Cˆå›#ÂÓªø º3ýê i«­\³4cLåScd>­»í&»ScãÐC€é9âwZx™’Ò”"Àõ0‚zi˜ðÞÿÇîVîžbYgwŠfz0¹ß2R;Sҳ˘XµŽ?ÈJ}wOåôaûgêOìíðE`Z¿Qw¥Aw´J¬:¿›¥ÙìÂ(¿³ SïJJºí&»ScãÐC€é9âwZöüÆ„f+’1¤Úó»^š0&›Ut3&¦žµnº¼ëìNÑŒC&·ó¢((éÏ(@Úlп±M2@Ôm`²&‰MƤc¡—´yJ·þ˜VÅo¥ÏER÷¦$cj–f³ ?÷1ER¯Æ.E»ÉîÔØ8ô`zŽøVÅo L6É:êV©j°l–fSˆ¿Œé}ãÈ)š~üìmÑLBϦìv~‚I ¢мáa‡1aR`C2%6Áæ\9{Øî²MXÁ©rþÀ”—=¿AÑ-m Dõ%Þzi˜ˆâ­cÚ ÑcÊ·‘wÝ©±qèÀ”Ÿ#~çUñ»HÐß=Û™v=Á¢Yš2&(Æ„¹LðãgwŠfz0¹ßÀé5nª GÊ»}LŠ-¯á*b­’»}Lú0½"‡ôM)¯Šßœ9q ¯1 áo5K3Ƥ¯©c¢ÜécÊ—¢Ýdwjlz0=GüΫâ·/sÒ»¾aÿM»4aL”äsWŽ8w.XæKÑn²;E3=˜ÜÎoÅ•”"6ýb—1“ˆÄÌŠa~Ý­fL!ê?TwrŠŠù›#Âóªøôç¢mÆK}òÛ,͆¯¼¾;:f¾í&»ScãÐC€é9âw^¿­#ƒ z7ûÿ˜ê¥Ù©çÏ]9ê6XæKÑn²;E3=˜ÜÎoŽFX²Yp§Ý>&`ÝJΡ(-ÙeL`ÿÜ —¡Û7;¿óºç·9j)I®tÌvi6»PÒý;@ʱ÷òûyWÙ‡LÏ¿óªø-˜(“ñ‘¿'&íÒŒ1Ò‡1ÅÒiÈ—¢ÝdwŠfz0¹ßÀ/ßÍmÆPÚÕ˜ôwbQBÔ¿ó¦S4 ÔºùXÎôþ˜VÅïTHY£ù¢TWRš¥ c‚òñüBz{Mz5v)ÚMv§ÆÆ¡‡ÓsÄï¼*~#²5¾ˆMg¬®¤4K3ÆôþJߌ)ô,Ë¥h7ÙÛ¢™„žLÅíüVÚ@7 úΰë`“¬IÇlORÙº’ò~X·¬[‚¯nåʪø]˜Ñnu›]3†¾Zš0&ÈoÆ„ïñ§^]Šv“Ý©±qèÀTž#~—Uñ[¿ŠhSÈ@DUÑ4KÆdãoÆ„X:G¹åR´›ìNÑŒC&·ó¨HH9'%z&Œm2&À$ðÚæ½Ë÷Ã%a.;Ÿdð/À´(~çìÌ!*דx꥙ÆðîüF~ÿo¯ÆÞŠv›Ý©±qè!Àôñ»¬Šßm…³ÝH¯¶rÍÒ„1AÀOSìZë–KÑn²;E3=˜üÎodýck½CÈé5`‡1 vÕM7®œæó*ÆDd,X8ÐW§¤”õÎï¨!æ’"V§rÍÒLcÂø9•# Î%Þòi箲;56=˜ž#~—Eñ[w 9ûVr3Z§Yš0&Ýw|H˜äÇÏîÍ8ô`ò;¿Aÿø%òË‘¶¶rÿû¿béßš!èÿÛ [ø~XÿÁv±°@JÓóÀ¦Uñ; „BŠÔJy+ñ»YšiL9Üž_&„÷Xù¥h7Ù‡LϿ˪øýêÞ`ÝyÙ)Ò_ÆÔ,M“µ~S×] \Šv“Ý)šqè!ÀÔéüæ(d¡Dyo+þ¯å[dªšm^7€ÉVR¡DMÈ,¦²û¿Órç·ÚŽ6ËûÜö¿ßõÒLcÂÏí%O½vr·s×Ù‡LϿ˪øb!*'ÑŸPLÍÒŒ1…ß))ú«ôOåR¸í&{S4³Ð#€)µ_Ýû®R v'Ôzc6“þ=Aù€uÖèãMPø~“Û}#˜_¦ëë™×˜þè Q±¹RRSµ4aLºÅå›1EélåRˆ?~v§ÆÆ¡GS ¿¯Ï{^4åuKÛ®v…jJJ³4Ó˜èãǬ ½¢¹Œ¼›ìNÑŒC&ßó[YOÖý,Jˆ6S*Dº±È1)Ô¿:¿7S2¯dÝÒÜmü_€iµóÛÄöµHUµK³Ù…>§rAßX»Ú¹›ìNC¦Çˆß×ç=/š¬¯Öbs—ípù/Ín—fŒ‰èãÇd³::Es{™ÔÙ¢‡L¾çw m#WJμy*—âË—òËå|‹1%ë}J˜¢ðÔpå_€iYü¶¯¯ÄÈÖÌ^‰ßõÒlv!Á§ó;ìÕØ­h×Ù‡L¿¯Ï{^4ÙNá“0–ÆZ·^š1¦òù3`é1¦{ŠeÝ)šqè!Àä{~'¶^u–¤ö]w)60Øhc)Yö“>œ²Í ¤sJ·þ˜VÅï‚b¶í%‡\Ý.h—f³ sþôÊêø1¥p)ÚMv§ÆÆ¡‡ÓcÄïëóžnLϰé¹T~LÍÒ\cúLI‰Œ=š})ÚMv§hÆ¡‡“ïùÍf­«u.‰7°Å“$(º·`£=[†áøzuX‚YL•ó¦Uñ•Œ`$Ýc5‰§]šN{·Æd£óü“_¥>?~v§ÆÆ¡‡ÓcÄïëóž~·fK‹Ýª®¶rÍÒìT®ÀoæcŠ—¢Ýdo‹fz0E·ó;*MB‰¡PÊR¶€IIµ¸Û$aH󃵊1A6u mÖ5ä©ìþÀ×^ê‹8‚ÜÖ¬¼Zš2&þÔXÁΕ”?S,«ìNCϦøñ;®ŠßÑñ2…¢/ŠÊ©Yš¼ÍBù¸ *yê1¦x)ÚMv§hÆ¡‡“Ûù]D¹Nà×äéð2è|¡.c›0®¤IJ¡#=|?L ­S Å©@õ/À´ìù­t7KÌErs%¥^š1&þuI-E:'¿ñ6ò®³;56=˜ž#~ÇUñ̓-‹¾`«­\³4y›ÙÕ®ëÏ¨ìæ¥xEs)ÚMv§hÆ¡‡“ÛùB ’ÙÛF}Kì“’ž@·õ¿¶Äï×à ¯û»J`ãWÓªømŸ¤L.Ù¬›¿ÀÔ,MjLYóÇÁÂFÈtjìR´›ìNC¦çˆßqÙó»älC†Be{Ú.ÍÁ=%5–Üx™âmä]gwŠfz0¹ß) H¦0ÚcLJ´‚M^Y?…=Æd,õ'« iÞkð/À´<ð@ÁR «íÒ¤Æò»©òŘ2u^¤xO±¬³;56=˜ž#~ÇUñ›ô”lÊmª›ßÚ¥cz¥oÆ”:î)æ?»S4ãÐC€ÉíüŽŒÅæN#¼ÇNn0&V†h¦º„xNzþ ›iµnK0Ùœñoö1ÅEñ[÷´![c•~‹¹zù5K“3ÇÀ›1¥Üx™bùñ³;56=˜ž#~Çå—Ö¦V¬’+?æviü6‹¥À½ÿ;,ÜS,ëìmÑLBÏ&pÅï$9è+#Z'“¬Ñc"ÓRÌ4`Ü&{g±>K°1"ß&Xíü–¤ûËDú%ÚÀ˜¿Œ©^šM{FþhL‰{/?¸Ú¹›ìNCÏ&xŽø «âw6ûux]‚¯¯¤4Kã·™Ó§ó[©cI‘àR´›ìNÑŒC&ßöDôg“CI"Ò›ŒéuCöÕ7.eÞŠT1&}õ[+*—y~ø/À´*~g%6¶¥Ø_é/05K³iÏÈŸ>&ÐÜ©1üñ³;56=˜ž#~âø­;.fæ‘”ïT]¹ÍÒLc åv°Œ¥{*ôãgwŠfz0¹â7‰r¥s ;³›Óëf DŒ6nÓ]ÀêJ´Ÿ#µ]VÅoQ&"Ù~óµn³4›ÄcS7c  øÇÏîÔØ8ô`zŽø «âw¡ÈÉü{‚~%S³4cL„)›Ñµ_4—¢ÝdwŠfz0¹â·`Êfܬ˒·€IQͼÍE(‘9ënÓëaÓ¿í®+sú&0-{~§¤•9Z+ú`j–f“xRùÜÇä:'¿py×Ù‡LÏ¿aYüŽÌæÎRNõ]¹zi¦1é6ýØBï(nE»ÎîÍ8ô`rÅo»‘ÂkäFÂ=ñûÿGdmÛ Ì»{³ó[Æd“!FH_¦ÕÎoëB3¬$(¥öüª—fÓžåÕ0òž](©#~Cùñ³;56=˜ž#~òç·n¬ƒn±YwJ05K3Æ„øécÊ‚ëxy×ÙÛ¢™„žLèÚždëQÎf—LgÚdL¤ÏviY¡igZ&¾VÈ(… éþ÷› –¸,~£âI[©îÊ5KSÆôñüëªèÔØ­h×Ù‡žLøñWÅoÀ¨¿‚¨›‡êo³4cLQî·™²ê0&¼í&»S4ãÐC€Éµ=ÉT'{K2KÄ=Æ¤ÏØ5÷\ÌXqKü~=,’ õM`Zx Æß^- •çw»4cLüë+ÏÝ&^¼§XÖÙ‡LÏ¿qµó;(áWòªo¢R*ÆÔ,MS.Ÿ®\òÝ^íÜMv§hÆ¡‡“k{òêr|AƒîCãÖ•”×ÁšM! lÄ'ljLú°1%‰Áxæ7OåpUüfDŠÑŽ(BLõÒtÚs¾uLýß)) /E»ÉîÔØ8ô`zŽøËß¹èÛ=é;šRÝù]/M“ õ¸“²ìNW.ÞíÜuv§hÆ¡‡“k{"¥£y1ذîMƤoo3 GÖÆ‚;nu*§{‘h“ÅRœûü 0-‹ß’þäYw™X¼¬—f³ ßç²ïÙ…¹×ù·¢]gwjlz0=GüÆeÛ»Ên#¥KwjiƘˆî›ßú‹êÒìÛˤÎîÍ8ô`rmODÿÌŠJ@¤oá¸LJzt(IL]£Í»rú0)_*ô27ø¦øËâ·˜[²Á•ø]/Íf¾§¤0uÚðV´ëìNC¦çˆß¸,~Gý*0]ƪó»Yš0¦”ðs*'¥g{B·¢]go‹fz0‘ÛùM¬l)Ú'Öñ®»@$;r¢À\0m:XêÃJ—^éY1ý‹ÀD˶'úý™l\‹ßíÒLcŠñv°Têõ1ÑíeRgwjlz0ÑsÄoZ¿í²'+)ªý»4aL)F¼“`ê\ KÑn²;E3=˜üÎffl"BàÀ «°é. Ïè_:Hvæ‹ãûa Ö+¯°¿Ú.@«â·Í‘,¥P”Êó»YšiLñ?Œ©äÎÉ/áŸÝ©±qè!Àôñ›–;¿³nÛíÕZJ¨{Lê¥ c’òÛÇ${o³»»ÎîÍ8ô`r;¿ÍÝ^ÉŽ„¢ú]I·Á¬A²ùO7¦eâûa}N™gŨo¶ ТøQí!Û€“˜ª—_³4cL>“x8ô†ÿøÙ‡LÏ¿iUüŽYJüEwUÑ4KÆÄ’ï·Y¤ÒF˜èR´›ìNÑŒC&·ó;’ QRÒDñºì1¦ÄŒúYfÌ\l»ÿ>lS®“¾ÿcˆ_ÝÊ­Šß(º³û9kñ»YšÝ•‹ðÛÇ”sçä—.E»ÉîÔØ8ô`zŽøM«âwÊ 9C±IÕ•”fi˜ìDãfL”:Ã]Šv“Ý)šqè!ÀäÛž(ŸHðꓤ[ –ÿû¿dê‰rëtÞìc²ž (¶+_+GËâ7êVIÿNl¼·båõÒìTNò‡1Q÷>&ÝŠvÝ©±qè!Àôñ›VÅo%ülk]ôw𘚥c‚ôéü&îõ1ñ¥h7ÙÛ¢™„žLìv~P*,Zð¥HÞ¼+g@  „Gwä@[Fq¯‡)›°£ýľL¼Üù-©báTS³4;•Cþ0&Ò?B§Æîvî:»ScãÐ3€‰Ÿ#~ó²çwx†¬OLš¥cŠé£1A§Ç„o#ï:»S4ãÐC€Éíü¶h†*d—ÕqÓ] [ƒ$#À°9‰7JIÉÏÃWOåxyà¥þA0Žpe­Ó.ÍÆÛ%U)vä¾§XÖÙ‡LÏ¿yµó›Í„ôGÏRÖi—&Œ‰òo½Õ ¯h®vî&»S4ãÐC€ÉíüF´ixúÛ}]uØìüβn,¢" l]â}=¬WDb†Hß<•ãeÛ“,%Æ×Ý\ŸÊÕKÆ„Èw|7x5v{™ÔÙ‡LÏ¿yUüæh5ÌÛ†R5"¼Yš0&JñsW u,ùR´›ìNÑŒC&·ó•éÝ@Ö%ì2&$…&bs²ãñ=Æ„ K)’å«WRx¹ó[+#gÝŒ+©®.ñ6K³Ù…?“µwjìn箳;56=˜ž#~órç7J2ÇD›H]w~×K3ÆÄásWÎ<º;Es·s×Ù¢‡Lnç7E›¤[Ìü7Oå²YOa\JÉ{ –¯‡S ¯)9~u¯Šß`ó· †·ÿÄG„×K³iÏùã’jÀÔé•ãKÑn²;56=˜ž#~ó²çwÒ÷Žþt°vh–fŒ‰â=ÁB¡:ŒIn#ï:{[4“Ð3€IÜÎï×V.k©Ûe7ØôcÊL9F£Kº-Û’b÷*lB¨â¢ê}˜dYü¹ØI€èþ²öü®—&Œ)rþö ¡s»@nE»ÎîÔØ8ô `’çˆß²*~£˜=‡ ²¦X]âm–fŒ‰²|“ô:¿åR´›ìNÑŒC&·ó›ìFˆyû˜¿Ýî\¹l¦±YQX7e7Æø¾S(A?2¥KæõM`Z¿Í*óË%¢Ò˜š¥Ù´gøÜ.PX‚ŽŽ)·¢]gwjlz0=Gü–Uñ›P+˜ƒM¼Uƒe³4eLá3WÎ.‰uІ~üìNÑŒC&·ó›ÍFDÙ L[À¤¤G7!a¶MÙ¦ç·>¬< 0ØøW­ueÙöD €Íº‹õ˯]šùÊ+Xߌ)vN~åö2©³;56=˜ž#~˪ø­ÅÖ^Y¤žÄ[/Íò/câîÛìR´›ìNÑŒC&ßóÛÆM,’Ìq÷TNñȃY:•­v÷ú‡TªeƒB¿)~ËòÀK;)Dýú”øVžßÍÒlv!ÀGÇTŽÓ“ î)–uv§ÆÆ¡‡ÓsÄoY¿¥è¬¤BÊ05K3ÆÓÇ {[¹KÑn²;E3=˜ÜÎo!Jvÿ0¢ ÙcL”c $.·éù­gJú™éFR7”ߦUñ‹ÒÚX»¤¶K3—TÁp×X‰=k¹í&»ScãÐC€é9â·,ÛžXƒ2ÖMWíÍÒTc*ŸÎoè\H·—I½-šIèÀ”ÜÎo1a,$ó0å~“1鳺×mEž{½UŒ ž Φ™ð75¦´j{b­úi”h¶Úk¬YšùÊß#Â^/¬Þ$Þty™4Ù‡žLé9âwZ¿CIfx¤/æL¯ ´K“·ø=• ÒaLéR´›ìNÑŒC&·óÛ&á™EU0­h“1eI6 Åv‚)o:XêÃúÚ×]ŽþúªçwZ·=ÑÙý˜B•çW»4ÄC·“n–{FqéãeRewjlz0=GüN‹âw Ñþ¥;âJ˜l—&o3dùìÿÍÖµS4oE»ÍîÍ8ô`ò=¿E‚˜»]z5‡îjLˆ1(ãAä°é.`gkú²i×øÍ»riÝó›åÝWbå`Ù,Í\RSúÜ.Èл+—>FÞUv§ÆÆ¡‡ÓsÄï´,~¿ ¦­72H½•«—fSw|›ÆyEs+Úuv§hÆ¡‡“Ûù­oƒRóüæÝ>¦œ¬=Sƒ`*ö.cJ¬ÿÐÌvß.~soZx™)P¶éŸùïÉo»4ó•ó™·¯|NçwúL±¬²;56=˜ž#~§Eñ[_Ë1ÑRÕ.Ð.ÍSÊ÷Íï9÷¶rùÇÏîÍ8ô`r;¿SÑ UdæÂÖK¼Ç˜ŠÂº„XìpÞ»Äûz€^†¾¹Ä©rþ/À´(~gDÓÙŠ>¥’ š¥9cºʘºÀT~üìNC¦çˆßiUü¶‰Htß¹6Šk–&o3»v¿Íb‘Ž0™/E»ÉÞÍ$ô `ÊnçwF-r“™ÊËbw1¡dò”yž m‰ß¯‡s1s¡üM?¦¼Úùm×kJ1rýÿ¾ü𥙯ø£1eJS¹|µs7Ù‡žLù9âw^¿Íƒ¨`Iúümh—fŒ)~f~EÀÐ&3üøÙ¢‡Lnç·MªÔ­g–H‰òæ””CÔÍXJ$Å\Î÷S `”I¿ó‹vÿL«âw²Yé ’yDÔ—x륙¯<‡__ùB½—ߥh7Ù‡LÏ¿ó²çw€ôjªNo)ñ¿[¹ziv*ÇŸ›ßQ_;½¢¹¼ëìNÑŒC&·ó;%Æd㦈_B{ŒIwp –8‡]wb½‚„ùuø›À´*~gë™ÈÙì!Bu%¥YšMâÉáWc‚ØF/E»ÉîÔØ8ô`zŽø—^ê®A™¿T‡jÿß,MÞffèúaLvÇË/š{ŠeÝ)šqè!Àäv~ëÖ@ <‰(u=£8%=Ìf!ƒJfÜ<•Ó‡Ùp<’âøW­uórç·íf%ŒªS¹fiƘÞíïÙ…A:S¾Û¹ëìNC¦çˆßyµó›³õ¼(õ× Sc­[-M5¦ôéÊ}ÙMûE“üìNÑŒC&¿ó»d,vÖì×÷†éIï߉ ßeLº‰¬Ó€ã7Ûòjç÷k\K‘ëS¹fiƘ>:¦Èë(Ä«±«»ÉîÔØ8ô`zŽø—=¿•¼F¹@Õ•Û,ÍSú½+§4§Ã˜Êmä]go‹fz0·ó;¡î3 E‘W›ãÖ©œ>r¦ Aʦ“=Ì¥H”hê_¦²<ðRñ•lX^¡\¹¤6K3ÆøÃ˜„zÖ:åžbYgwjlz0•çˆßeyàed²fa3è¨îÊ5K3ÆÄ¿îQB‡f—{ŠeÝ)šqè!Àäw~ƒ]£ã,@a³©X TÑ_ˆå°Ë˜P’ýÈY_ßԘʪø©pÅZÝ|U:f³4cL>:¦Pïä·\Šv“Ý©±qè!Àôñ»,ÛžèLL\–T™xµK3Æô–¦ßŒ {]¹åö2©³;E3=˜ÜÎoDÅEe>»SRË@¡Xßß%ä¹A@Ř€Ì¹:€ý»|³Á²¬ŠßT¬ÿ=p®‡ª6KSÆ„Ÿ»r‚=©ðŸÝ©±qè!Àôñ»,‹ß²iÊf[÷1ÕK3Æùãù­ÀÔÙÿ—[Ñ®³;E3=˜ÜÎo;èO`{¶&ìMÆ@Šnã²Ò-³öØcLv9Ïæ„KÖoá›SY¿…t{HÁ²ê•k—fÓž9X9—Þ´çr+Úuv§ÆÆ¡‡ÓsÄï²*~ÛXE»™°¹ÄÛ,MSüeLPzÓ¥h7Ù¢‡Lnç7P E²þ¡­ucÓ] Ä×ý´íÅ>lòT˜ä«FqeUüNɦ ‹ðõêús%¥ZšÔ˜Púô1ñû¦WcåÇÏîÔØ8ô`zŽø]VÅ憎 üšªQÏ•«—&o³Xø÷T.t,)r¸í&{S4³Ð#€)·_ÝkD8“ÂBÆPòË]€v:¿‹>v·DYϦSIvæÍí²Ý|¾øÿ?0]_ϼÆR‰”4:Ú‡Rù15KSÆD¿Œ)£ÏÊs¸Ú¹›ìNC¦#~_Ÿ÷¼hìºGa{©¦Zü®—&o³È¿Œ)HgDx·¢]gwŠfz0ù/í­™t$k’ÜôüŽв—Žd­H:ôŠÆÎæ^™õà 4{ø_€iÙóûÑú@æjÚs»4eLð9•ãzÀty×Ù‡L¿¯Ï{^4™’¾– #QæºÁ²^š1¦wÈëmä5Î+š[Ñ®³;E3=˜\ñ›êN,$äB›s墵{d²KÑ&ŸïÓëá¢tUÿáøú}˜–Åo¶¦4…¹¦zi6í¹ü‡1AôÛr¸í:»ScãÐC€é1â÷õyÏ‹&cæ×N‚úæw½4cL’>o3›ÓÚ)šÛˤÎîÍ8ô`rÅï1Ç L/¥k$ÀczY¦»ÿ«Á¸É˜ìáDlR½œ ¾L˶'‹è×hŽ µÆT/MjŒù÷TŽrðuÌn/“:»ScãÐC€é1â÷õy/Mf“üR´‹ûÕËfiʘèãǤ[9ÿ(W¹òŸÝ)šqè!ÀäŠßº‰ A “(NdÞôüŽ€ Äv["½”óÆdK6;(ó×ÿ&0-Ûž~vva3­ª—_½4cL>îÜsIU8ÿñ³;56=˜#~_Ÿ÷¼h’rFÖWë%Wÿ˜ê¥ÉÛLëäîüÖ÷üû²e[41üøÙÛ¢™„žLѵ=Qú!ê+ݬZ`ãî‹1!¿Ú3mòS SÒS1&Ô5¡É[¹Ìþ`Š«â7‚¤¤²ÛŽk¬YšiLR>.©œS‡1ÅKÑn²;56=˜âsÄï¸,~§€hwá)Õw嚥ÉÛ, Ý]¹…Þî‚0ÝŠvÝ)šqè!ÀäÚžDÐR'Û‹eE˜-`z™3&q¶¡¼›ŒIF æ»þÚD~ ˜ÅosHb'ª6Œäo5K³S¹ÿј:/týãgwjlz0=GüŽ«â·Ä ¿àÆ(®Y¿ÍŠýëúØjéÓ¥h7Ù¢‡L®íIÄ"Ö%©ïá,;·JÞŒ©pB!ि¾]ÆT8cQÎD¶ü&0-Šß’9ÚP©²ð_`j—fÓ½•3Æbg+ߊv›Ý©±qè!Àôñ;®ŠßlÞ¥$Ý8ðßëíÒŒ1éæáfL|õ49Es)ÚMv§hÆ¡‡“k{Iq¥ÝV‰þÏ[%oÆ¤Ä –\0AÞÛʽFˆ‘’)Å_¦Uñ»˜W0Ý•–PÉÍÒÌW>ý2&EàÎK¼í&»ScãÐC€é9âw\¿eÆÅNâkwÁzi¦1A¾OL …ÔÛÊ]Šv“Ý)šqè!ÀäÚžDNvà¯|)ÙŒ—MÆD6J·([Ê%¥©~]1&}XAQФ˜xºü`Z¶=Q®kz¤æ®\³4cL>½}<`º½LêìNC¦çˆßqUüNh³$£óȱ¦ziü6ÓŸƒ¼›mT‡>æ\Šv“½-šIèÀÎoEak»±É›ŒI™¡u~³™v¦]É&‹sf±yW_Õ˜`¹ó[QšJ̦0Tâw³4;•KåÓ+G¥c{’án箳;56=˜à9â7¬ŠßºM{µ • ˜Ú¥ñÛLßòpKÙ ™;À?~v§hÆ¡‡“ÛùQĆX¿®ânmåLñЭ°nZÓ0½–ðº$Ÿ^fŒ_¦eÏïÖð‘l@`Řš¥iSúeL©3",Ãmä]gwjlz0=Gü†Õ—úŠ #›®ñ§hÚ¥ñÛ,§|ý¤Â{œL×Ë&»S4ãÐC€ÉíüŽADXwº1`Ú˜ÀôfL©`Êf÷j³ÂwS²}`´!N ÷Yþ˜V;¿•ĉþîIl{û˜š¥©ÆÄñWcêu~ÃÕÎÝdwjlz0=Gü†eÛ“,`ý®ö[¨¯¤ÔK“S9ý!Ü;‡læ®`º½LêìNÑŒC&·ó[ Rˆíc AÞìüÛ½f2ñ›eëJÊûaÖ°¹Å)mû&0-Šß9š5qHPy~5KÆd¶$7cÂÞ0‚ éÇÏîÔØ8ô`zŽø «¶'Z^¨_H’Úö¤Yš0&ój¼SìÓåeÒdwŠfz0ù¶'¥°îlEÿÞý×;ß)°þ…ƒEsTÜdLú0eÈÞî_¦Uñ["rˆbŽžRÊ5K³I<ù×%U?ãŽø —¢Ýdwjlz0=Gü†uÛ“Ì´Vë8VÀÔ,MSN©¤0áÇˤÊÞÍ$ô `B_üe-DºC€¼Ë˜(]Ò_J) Â[*ƤK²{0vxÚõÀ„«âwkBÖ?Y©ïÊÕKÓiÏáwva.K¼í&»ScãÐ3€ Ÿ#~ãªøms–Šé!¥ºÇÔ,Í4& ¹“ÙÛÄ0]Šv“Ý)šqè!ÀäŠßÌ)‘ÂKbk½ÙdLlsAùÓÞVîý°R‰lîXºü&0­¼$y]ÀÉ•íI³4cL×¡Ê û³tÄoüL±¬²;56=˜ž#~ãjçw¢—;uÐ&\îü@PD‘¬Èß—_»4ó•ôñüŠ:wåðn箳;56=˜ž#~ãªø]l*cbÎRïÿÛ¥ c23ØcìlåèR´›ìmÑLBÏ&rÄïÍ ú#"Ý{æ·ƒåcbˆA7c¶±à]IFýÀŠî~)~ó/­Šßlw’•Åé¿SÕÇÔ,Í<¿äã`a#A;[9ºí&»ScãÐ3€‰ž#~Ó†ø]@?Í”ÔfiƘøs‚”ma˜~í¿Ù¢‡L®í DF³¡|]¤å­Ë—LdÊnRTBˆ»}LÉþÙvfRÒ7ÅoZµ=±Æ‡Ä)b¨ïʵKS_ùôј̪®L——I“Ý©±qè!Àôñ›VÅïP"ènݵÃß·Y»4aLŒås*§„¸³•£KÑn²;E3=˜\Û°K¸ 0'kdÚíüÎúñéß÷e‚Y¦»±Š1éÃ6†H7‚úþ¦Q-Šßú¥¥1'åp\û1ÕK3)䃥nåB˜øÇÏîÔØ8ô`zŽøM«â·²ý Y£r¦êT®YšœÊÅ÷/ðu*‡z[¹KÑn²;E3=˜\ÛПm.E·dðòÑØcL…—"KŒy«Áòý°M†ãòM‰–mO‚yÀÄDA¸¾Ä[/MgJühLÔ»’B·—IÝ©±qè!Àôñ›VÅo}QdýéG)ï^í¿–—Æo³¤ÁåfL_&^0å?»S4ãÐC€Éµ=Á¬ÊSA¤€»SѸ.;†,°Ûù­'›üîü&0­ŠßdžAÌi¸¾+×,ÍS”OSÄØ9•£KÑn²;56=˜ž#~ÓªøÍJCRNv ­2ñj—Æo³”áãK¦´ø­´EÃáÇÏÞÍ$ô `b·óã« ­…Òî©\Á€ jæŽW`w®œ>,E7%‘¿z‰—Åï¬ß^²Ý¥~‘µKj³4Ó˜Ò¯“…LüìNCÏ&~ŽøÍ«â7šñ½"нž«—ÍÒ„1I¸ü©ÿ÷’¡wWŽ/E»ÉîÍ8ô`r;¿¶ ~˜8ì:XQÆ)ÙÌ8X¶€éý°@(ºÄojL¼Úù­ ÝÙZkæ¿ÀÔ.ÍNårüô1ýv€éjçn²;56=˜ž#~ó²ç7&²KYßî6ÿõü®—&Œ‰C¹¯f‰ý,;Àty×Ù¢‡Lnç·b©µÙ¤ vÅa÷T.[”nâ$åRv;¿õa¢È6PæûÀ¦ÕÎoý£°¹i’~$µƒe½4cL˜s§‰¯vî&»ScãÐC€é9â7¯{~ëF̵s»4aLôÆ$P:íü1ò®²;E3=˜ÜÎo´¦ŒdàÂeûTŽŠD*6éfl·óÛìRD0¢ScâUñ›ÈÆ•šK0WCUÛ¥c‚—¿ä›1QèÜ•ãôãgwjlz0=GüæUñ­å5 ¢²äªÁ²Yš0&ú½š%’ §1]Šv“Ý)šqè!Àäv~›HõgdÓ¾7‡¼Þߘ^ÆÝA Âö]9Å£œmt#†ùߦUñ;&Eh%X‚™*ÆÔ,Í|å ü2¦ØëcâKÑn²;56=˜ž#~ó²ø’Í ¦*V[¹fi˜X>}L’ä5hÙ&¹í:{[4“Ð3€IÜÎo;æ1oŸ$1mµ Xó¶ÉœÈæÃ–]I64GQøæ0YxÉ6P Ð4³êT®YšNâùø1‰Ô9ù•{ŠeÝ©±qèÀ$Ï¿eQüNYÿÿÃËì!§Šf7KÆ$úÀ͘ôÝÓ±=øñ³;E3=˜üÎo„Kâ˜mîÞ•³Ë$Å,raÁ·q°$,Œ!ŶoŽ—eÛkq£ÂÉZáÿÖX³4cL÷]¹¢ï¾Î‹Ü^&uv§ÆÆ¡‡ÓsÄoY¿#gÉ‘íÃ_ÆÔ,M†“èOª#~Ë¥h7Ù¢‡LþÀË€%A ‘¶SFMaJNwcç·™ž¤¬›i%^ߦeñ›u×E,v«¹¦fi>»?Œ©ÿò»í:»ScãÐC€é9â·,{~#ÚüšÊ]°]š0&-šûG$zWRä6ò®³;E3=˜ü—,1#¿x^Ù¾+'R‚‘%Ýn3&)PlßË‘¿z‰WVÅoÔMÛXH¥¦fiƘ°|fòûJ·Wc—¢Ýdwjlz0=Gü–å—\@·ü:¢®hv½4aL!Çx3& =?&¹§XÖÙ¢‡LþÀË`{ƒ˜­U2ïmåŒôݲ(é,™rÜöc*æõ­°ñ«À´*~ëvT7IA¬A¶¿›¥)cÂcâÂ=Æt)ÚMv§ÆÆ¡‡ÓsÄoY¿‘0šR«ï¿úæw³4~›If¹% ¥g{’.E»ÉÞÍ$ô `Jnç7+g1³ÖÌ ŸJÚ’bÖ9ýwOåôaÁ¤ðñ›ßiÙöDCÅFÂåX°´K3Æã=%ÅÚÚ:#ÂÒíeRgwjlz0¥çˆßiÙö„)ƒ$¶3  ˜š¥ñÛÌÆÝ–º“àÎV.Ý^&uv§hÆ¡‡“Ûù  ÛK²Ñ.{žß¦ž@(A7’·çÊ1‘ݕǔÍ%ö‹À´,~C6ÅLô“HÕ””fi2í¹Ü%eLQ«¬Sc·¢]gwjlz0=GüN«â7Ø(é`í‹!ÖÀT/M“]þ¿~œ%vNLÒ¥h7Ù¢‡L®ø"™û˜3¶dkˆ§-‰1’Máå°g÷~˜3—¢ 6•ožÊ¥Uñ›ôûSúXë»ríÒÄó«ÀçvA±û#»í&»ScãÐC€é9âwZ¿9%kaÎÕÛ¬]š0&6aòý6c%Û)š[Ñ®³;E3=˜\ñ›áÕŠ˜CØÚÊéÔ)¸qá馚1ÁË¿ã2eø&0­¼´{f²Ê +ϯfi˜ô/w;XäC¯Æ®)–Mv§ÆÆ¡‡ÓsÄï´Üùm&‰ƒ9ÀVžßÍÒ„1¾unÆÄ;âwºÛ¹ëìNÑŒC&WüÎÖGd:ÛàÊÝ))º¡P¦DdV¯Û~L/';ÀLh¿L«â7( ±fÑfDx³4aLò Ô¹ô5¦KÑn²;56=˜ž#~§Uñ[7`æyÙ͉¿—xë¥ c²‰f7c"îݕ˗¢Ýdo‹fz0eWüŽJxt3•€íŠÈvS´”ý))AôA EÄ8§[ÿLyUü.ÀP²]jαFÐ,MѧÆln|GcÊ—¢Ýdwjlz0åçˆßyUüJúus¬­ºj°l–&ŒÉœÆoÆ„úÓèÍ¥h7Ù¢‡L®øÙ³ ókÖ‚_c·¢]gwjlz0=GüΫâw"ˆ “]7­r›¥ cRŽp¿Í¨Dì¼ÍÊ¥h7ÙÛ¢™„žLÅ¿­Á!Ûm5¢˜ÂÖ0#=b³ÁQ‘p>è¤fL6NÖ†}Húmúé>üÀTVÅoQBvHY°6Šk–&“x¬mäö•×}]g+W.E»ÉîÔØ8ô `*Ͽ˪ømoe;öÊúv­Œâš¥cŠ—a¢1&H?¦r)ÚMv§hÆ¡‡“o{bgFHŒ ‘v,9CÐÇ̱³ð”ôÔŒ)*†—bS¿ɘʪø™ÍÄEI$…Ú©^šÍ. é3»0AÏŒ°àŸÝ©±qè!Àôñ»¬ŠßÊ`õW û†Àõ•”fi˜„?ƒ_u+×óÊ)—¢ÝdwŠfz0ù/‹ä BJ1„¸;WŽTìÖ2;aÛÖ˜(‡”ô5ð«ÃÊjç·Ùpýã ±¦ji˜€?š[¢L¹ ðŸÝ©±qè!Àôñ»,¼´cÒ„úrEª4¦fiƘ„ó¯ÆÔ»ù]î)–uv§hÆ¡‡“Ûù^®'íš¶û˜’AñëpnnBÙô1é&'”`7ŸÃ7,˪øÍbG”Å\ÛCu%¥Yš0&³Lº“²Òž\p)ÚMv§ÆÆ¡‡ÓsÄï²Üù£ÅT’¤ ˜š¥c ñ—1…Þ•”r·s×Ù¢‡L—Œ’]Ê.c’¨CÒÍàünÝÇÍhåeȤ›¹oÓ¢ømþ/D Òf¼ÿ­±fiâùUbùÌ.´Ž­N•?»ScãÐC€é9âwY¿!%»Õ‰’TS³4aL˜èv ÝvùS —¢ÝdoŠfz0•ö«{3&›èRÀΡKÞÄ+DA™–ˆÛwåÈ }õß6Sý‹í××3¯±dSíl5bhS½4eLø™ö ^Ý^&uv§ÆÆ¡GS ¿¯Ï{^4%‚nÀ²ÝmKÕÍïvi˜à?§r¹r%¼í6»S4ãÐC€É·=É!»b¾HiûT™L!²!g°Lï‡%&³üŽ,_<•»¾žy%sêÒwŠä¸¦fi6»0á]cvøèËJ×üìNC¦Çˆß×ç½R4¯ŽôUA©*šzi˜ôeöјuF„—@?~v§hÆ¡‡“Ûù­€’_N­Ñ rw[k¥ è–Êvç7+#L)‡¯Ójç·q^´.7Ázva³4qIµ9ñ7c ±sí©„«»ÉîÔØ8ô`zŒø}}Þ E£od»h*\2W§rÍÒ„1éò–4È€¤S4—¢ÝdwŠfz0ùß¶èŽ,‰9Àl2¦H9…5 ¶ÚÞ·ô‚Í.˜Cùâ©ÜõõÌk,e,… GT”®Œâš¥ cJ>“xŠÄ+¿í&»ScãÐC€é1â÷õyÏ‹Fép. “–r†jA³4~›‘¹bì½ÍnE»ÎîÍ8ô`ò;¿ôãP„Èƒìº PVhÒÿ´,¸%~¿ÆTR¶ñFßFp}=ó³#x`F ©;¿ë¥ ck¸\RKì´¤”p·s×Ù‡L¿¯Ï{^4YɈ¾c#IŽÕ\¹viü6Svî4AéØž–x+Úuö¶h&¡gSô;¿Én^)–ê¯'ó.c"²QzúúfeŠ»SRìO }‘Ê7Åï¸(~ëßEìv‘ú>f³4Ó˜¸|&ñè®®WcñÇÏîÔØ8ô `ŠÏ¿ã²ç·™¯GýŠ#V£uÚ¥ cJñãù­¿ÊÜ9•‹·‘wÝ)šqè!Àäw~S,©Ä×͆-Û#=\tg!˜Á¨Ï.cb3QWX‚/Zë^_ϼÆR»k£{ë—õÒŒ1E¼uL1ÁN}Œ¼«ìNC¦çˆßqµóÛnTq–¥4#Âë¥ c2‡ëw€ú{òï1éõÇÏîÍ8ô`ò;¿1€yÜšëw ÛŒ Èv€f÷²`©T3&ýÍUÏBñ«À´Úù͹°œ"VîÍÒ„1)¿I ˆtÓÕÎÝdwjlz0=GüŽ«â7—¬¿€l®"©j~k–&ŒÉN©¯·™õ€éR´›ìNÑŒC&·óB*Ê–¢;)y×]À:$u×Â(±Ìe¢Š1éÜtGå›#¯¯g^c¦áÇt?žs©€©Yš0&;l¼“Ý%ìÔØ¥h7Ù‡LÏ¿ãªøˆrÑw¾Hrå.P-Í}ÆY£ EëMþñ³;E3=˜ü—ù5C+K±ì­+)ú0J0©CÑÝN6“~J¶ý¬h>-ó_€iUüNœRa4q9×[¹ziâ’ª­ÏìÂX¨sò/E»ÉîÔØ8ô`zŽøÅï×€  æ‘‘ë –ÍÒŒ1Q(Æ¥sbáÇÏÞÍ$ô `·óÛ¦sKŠdãÊ(îö1‘µnݹˆlmåÞ[c¦qJÊõõ,Ô˜²Ç@2ÔžßÍÒlÚ3ÇcÂ@Îo¸½LêìNCÏ&xŽø «â7Ò/ÛD¼­ÝÿkW/M“ÝξS"ìlåàR´›ìNÑŒC&ßó;©õY7¡9‡ÝÎo IÊË\@i·I¶I—H”s}˜VÅï¦á°Í±’ ˜š¥Ù´ç ¿Œ‰¤ÓÄ —¢Ýdwjlz0=Gü†Uñ;BäÙ ãßý»4aL¤¿Å›1ÙœÇNÑПÝ)šqè!Àäv~SF ¬/xýs§´;WY_ßʶì s{JŠ>læ bÑôÍKXx‰6ç.%¸ôWÇl—&“x8Þ¾ò%v\Rõïÿãgwjlz0=Gü†Eñ;) )Ê`Ù.ûoÑ4K3Æ$?&L"½¢y+Úmv§hÆ¡‡“/~D³jÓ×z’WÓÎ$^ä¨)KTˆÙu°DfÝ”$Ð} |sàåõõ,Ôýµ'Û—beFØ.ͦ=G¸I g…ÆN]Šv“Ý©±qè!ÀôñVÅo(æJmS†BubÒ.MÈÇ]mdc§hòŸÝ)šqè!ÀäŠßTKãå»ýÚÊí0&(d{¹\t'¸7¾éýðË*¬—쫌iUüΊ“ *Rj©Yš0&ݧþN{Øéc‚KÑn²;56=˜ž#~Ãjç7bŠJHX ¥ß\/M“îùï·;²ä0áÕÎÝdo‹fz0¡+~»'—í1ayÉ";“xA"°`ÜöcÒ‡ÙFƒÚe¶ôÍÎo\¿À눒íç_ÊÕKÆ„ÿ™ÄcV‹?~v§ÆÆ¡g>GüÆeÏoRvœ‹½_Cu‰·Yš0&Ý{Üo3¤ÜëcÂÛÈ»ÎîÍ8ô`òÅoÌÙ|Ê¡èÆj﯑ž`—pÈÌ/O[‘jÆÌîSqDè«À´ìù-L˜mwŠÕEñvi˜ùž+gû½—ßmä]gwjlz0=GüÆUñ›À4B©4¦vi˜Bùm#¿oµyEs)ÚMv§hÆ¡‡Sgॾy‘$ë¾Ðnç·Ýw‹Æµ §½Ë÷Ãååî Í/Úý 0-w~[{,R0Ĭ4¦fi6íù×-˜ÑÚ´ü»Û¹ëìNC¦çˆß¸ÚùMÉ|”£˜l LõÒŒ1åtßüÖ÷w„I¼Ú¹›ìNÑŒC¦ÎÀK…2p2î²;‰WA)˜[t»´=WN†ˆ‰@ñœ¾ L‹âw¶ØB¢ÛZêÚS³4›öLùîcbÛãwj,ýøÙ‡LÏ¿qYüÆ$`¥¡¶Ö­—Æo3,9Þzˆ¾Ìb1ÝŠvÝ)šqè!ÀÔ³=aŒv¸f½1q—1qQx‰Qÿ⻓> úTVF‘¾z‰—;¿_FÁ¢¥œëI¼õÒÄó«üΕcÀ^/ÞíÜuv§ÆÆ¡‡ÓsÄo\¿K,‚þGÖïüoÑ´Kã·*aúô1aì] ðãgo‹fz0‘#~¿^b2ƒ%{»SR¢ øÄôšX…»}LѼ«C}”ô×à€‰VÅïÈB¸Ô:f»4›Äc³˜ïI<Ü™’RèR´›ìNCÏ&zŽøM«â·¾TÍð8–z|S³4;•‹ŸùŠÈúÓê üøÙ¢‡L¾í‰X÷5{‡í»röW7SÞl»ã]ƤcNF/çûÀ¦Uñ»d€hÕÁµ\Ð.Í|åÓÿãîov,è‘+Ap_O‘ˉEf“öGr€Y5ÐÀlšÅ, ÕR ­†JY£’Óýôcæ×ýƤ9¸ –gJ_¦dæ÷šÇÞ·ltß7[9:í&º“c}×M ÓsÈoš%¿‰Í¢6ªµ¾’Ò˜FSy÷˜èZ}7%…NF»‰î$Mßu“Ât3ðmòd>€Ë“@ ÅJŠ™Â˜&ª“n{ÉFÒÙ…ù"¦Yò;#ÚP¤s¹ú!­[™Fºò!OâIáæä—øËîäXßu“Âôò›fÉï(ØnU•†cjL#މÞûD)wˆéd´›èNÒô]7)LþÀ˨;ÐXÐÄZËùm­HѶZŒs†µ+)¯‡“D 0É”O’ß4ÛùM’õì¾ãOò»5 ñûTNñä-b:Û¹›èNŽõ]7)LÏ!¿iZóÛqMî˜ $ÿl°¬MŽ©ÈoŽ Ò]aº„¼ëèNÒô]7)LþÀ˨…1ë&ÔôÊWû˜0ä©DHWßÎB“Ý®ÛÌq†O^I¡Yò[Ñ#i°¤*Ž©1fÆw“–’tsí‰NF»‰îäXßu“Âôò›f;¿uI/rHŠ…j|Sk ¦¬ÕãBL@w²§|¶s7ÑÛ¤¸îQ˜ØíüF0µï¢Å!É‹YBL&é†:â°G²éüÖª¨»¤>9‰÷üzÆ9–ˆ4¢[ˆõV®1 9¦÷í2éá›;í&º“c}×= ?‡üæéÎo0Õ°füjakÊQyߕӺécâ«»Žî$Mßu“Âäv~keNHÉäqƒ2UKˆ)S/±±—Hˈ)€bŠ œò'·rZ˜¦5¿ƒDÆrÊu»@c & xü—[Ät y×Ñë»nR˜žC~ó,ù­k²h1ui©Sc ¦?̕ǀx·šŒvÝIš¾ë&…Éíü¶®ë¨[)MxMú¥ÂL„²ØMwÝTÈ‹9_S°,%ñq5À'G„ó,ù-ŠÞRýcb5"¼5¦= _ÂÍí>í&º“c}×M ÓsÈož%¿‰t¿ ;…;•VNk &.éÝùøn5““Ñn¢·I3pÝ£0‰Ûù­û©\ŠMÖ­è*b"ÈS»¾¼Œ˜ôa…Z"”^óY>U˜d^ö…XÄÆ¶ýDå­i8í9¾9&$79öÖ2©¢;9ÖwÝ£0ÉsÈo™%¿¥÷Ø%ŠU»@c!& ðFLñNYNF»‰î$Mßu“Âäv~£®ÁцëS´Š˜lHÔ%ÜÚ·Vû˜ìáRÐäÆÃGõ˜d–üÎ€Ì BæX¡oMƒÛZè¯?‰à• ~ùÑë»nR˜žC~Ë´æ·îÙmt®‰ÉÆ4BLü­`âÌ–KÈ»Žî$Mßu“ÂtÓùÍÁ.ª§6zz1±¢ѽk°¾š¥­ÜëaÅh)Ygtø(bš%¿Aÿ ÝÇšcjMÄ”óÙÄûgSLÅ;ÄÄ_~t'Çú®›¦çß2K~Û54c%ìÊh5W®1 “B¦«Çòk˜·—4'£ÝDw’¦ïºIaò5¿SÈL{SÒ*b’LŒ$Z‰mþâ"bÒ‡%곑ìÐà“…i–üæTì¢àJÁ²18¦€W!ß ¼”“Ñn¢;9Öwݤ0=‡ü–iòcÖ·(ýì1iMÄdçOçjG뀟4£]Gw’¦ïºIar;¿’ˆÖ¿z*w°KÂ9ÛÞb©0gæXìþÿ'Éo™–= bšµ6¡Ô/kÓ1™ÔÉ…˜b¼é•“KˤŽîäXßu“Âôò[fÉïÀ6µ•tï@Õ”ÔÖ4@LPðj´{í7…)Œv½Mšë…)¹ß±µHRló]“ÝÓJlÄyÄÕÎo{8g)¶,ŸœÄ›¦^Ú¼îiõ³¨„âZÓˆcÒ¢ûÍ1•›Â”®)–ut'Çú®{¦ôò;Í’ß`r´É­\ #hLÄs¼n~ƒî'nNå|ùѤé»nR˜|ÍoaÛR•ãÌ~MZ÷φQJÖQ:q«¤BLöp)Ùäâ´<~²0ÍËž„!˜ª)ü<`iM#Äåš+G§Ž—co-“*º“c}×M ÓsÈï4ÝùÍ(ˆB1Ô£uZÓ1é;tq­À‰nÈïtµs×Ѥé»nR˜|Íoâ’’ÖRÓÞ\k°Ô¿¸ ‹$ÂhõiµINʵS½O¦YÙIY0év¼BLiˆ˜¸üáTî®0Z&Mt'Çú®›¦çßi–üV(’ “£I5%¥1 SÈüFL\ò ùäËî$Mßu“Âäv~Û¬’| Ä•ŒÇŒ†ÄTP_@ÔW…ÊÄ”ï 1ÓqbHl#í>y*—fÉïl­s¤ZZ§5 S ñ:ùÕ2ß´ ¤“Ñn¢;9Öwݤ0=‡üN³ä7;K@¦^_õ15¦þj¦;~~ŸÊQº-L'£ÝDw’¦ïºIar;¿£î ŽvÞèH.!&­ÅR0é_-kÃ^ ˜l¦îéð“ –izà%&Û“àT¦Ú4@LZçß –îîc¦kŠeÝɱ¾ë&…é9äwš%¿MQ4G“aE©ÚS5k„¼Å»æ·|2ÚMô6i®{¦ìv~ÛņDH?8š·W&ñêºB$rJ«êöpÎŒ¬ø“wåò,ùm¢ŠS±ÛE? Sc &¼Pù¡+s“c'£ÝDwr¬ïºGaÊÏ!¿ó,ùMuiňúTäwc!¦Hñ˜(Ý ¦|2ÚMt'iú®›&·ó;›R\ÑýTJ¶—[)Lz’1æ¶,°¬.`çB™ƒ¾bŸlȳä·èÆR‹l ŠJêS¹Ú4@L¦ß|Ý.ÈñNW>ŸŒvÝɱ¾ë&…é9äwž'¿íöC±‹Õ\7XÖ¦bJï †˜î’æÍhWѤé»nR˜ÜÎ錄k hZå6}t1eXm‡TVïÊÙÄ!“Æ"¦YòÛ &AS‰ª Sc &¹Nå´‚„ò;ŸŒvÝɱ¾ë&…é9äwž%¿%%!&Š¥ÒcnMĤ0øÍ1!Ý Ågùò£;IÓwݤ0¹ß¢)†bÃÍK8†(-!& &S|Ãñ¦1éÃI4¤,ñ“ –y–üN‘ÕÛ¦wb®¤uÓ1)ˆ|+XÈí0‚|2ÚMt'Çú®›¦çßy–üŽ‘Ù%YÃáwåjÓ1é‹piåâ]I>í&º“4}×M “Ûù-Q«+/&À½Š˜Äxo6ùJ…\«ˆÉdõA²]²ø¨‚ež$¿s±^ T¨¤uÓ1Ä7bÒêMƒe._~t'Çú®›¦çßyZö„Y÷ÕºÀÚÌ¿ŠcªMÄ$X®ƒî"Ê ù].-“:z›4×= Sq;¿9k®[û5䌴Œ˜"D›á+Z‹—9&ÔY-WHñÉ»rešüÆ\Lð·ÄJ©1“PúFLw}Låb´ëèNŽõ]÷(Lå9äw™&¿!÷Yr¬ÕÓ1é®åZÍ@707 –åb´ëèNÒô]7)Lnç7#KQУÛ9…La1éNßÝThe[FLöpNQÛ'Éï2K~ë>Ü„¦Ú4œöÞ}L1Þ"¦“Ñn¢;9Öwݤ0=…ü¾>ïqÒdÝg ®}šÎ±îünL#ÄDïÕÝ.EÞpLñlçn¢·I3pÝ£0E·ó[]OÒê¤Û©ƒé¡ÄĘ%EÅ>W“M/&R|®]àúzÆ9¦oºþ)bTa¬^6¦Ñì®?IÑ3»½rú›ŒvÝɱ¾ë…)>‡üŽÓ/-‰É„ÉÖ/kÓ1…„oÄD|ƒ˜â5ŲŽî$Mßu“Âäw~+Ò1‘ÝÝZÛÞJa:tyÄôu%¬ê1ÑÑ¡`ãÄc•¹ß¦éÎo*ZO"§H©ÖcªMÄD”Þš_ýI<ú›]íÜut'Çú®›¦çßq–üŒŠù%E²Õ©\c!¦øžù­'ä&iNF»‰î$Mßu“Âäv~ç šê‰l¶2U+ˆ pZó|ÑÍàê\9}Ø”…Äôœøs}L××3α”æŒŠqRÝ’R›F³ !¾uå3ø÷1õ7»í:º“c}×M ÓsÈï8ÝùM¯4†jJjc ¦`“Q.ÄxC~Ç«»Žî$Mßu“Âäk~ÛÀ È,$A+ë"Ç„!&Ý_(êÕ¹r(±zã »ßO¶ Äé—E«%Û†©¾Ä[›†³ ¿ïcæ(wtÁ5ŲŽîäXßu“Âôò;Î’ßsfÅȪ+)i€˜•kç¥ÀM»@<í&º“4}×M “¯ù­{Ž’r DÛ–-žÊ™ü%&FÒÏqy¯u ˜ w6u‚ÏÍ•»¾žqŽ¥ãF1ê5•æWkÍ.ŒoZGnÈïx y×Ñë»nR˜žC~ÇYò[¿a»V•K=W¾1Óu]ÀŽ†ØŸ+g"ý_~ô6i®{&ð;¿M7éÁ"PVû˜ôý³îL)Œ–^‰ÁhœÉ'Éo˜x©;Ú¢ÿŽTKëÖ¦b¤÷í‚ôbƒ¼»¦XÖÑë»îQ˜à9ä7Ì’ß%šh-Øæ¡’¤hMýÕ̤ßß|¡8ýÍNF»‰î$Mßu“Âäv~+PŠlrùºûIJ4Œ@ÿbëaÒØµÂ-"&›-ŽZ8ë[üÉ+)0K~ë¦ ‹C¸¨êcjL£Ù…ù­Ç¤Nº!¿ád´›èNŽõ]7)LÏ!¿a–üæ’É¿¬ëkÕ.ИFˆ)bøFLé†ü†“Ñn¢;IÓwݤ0¹ß˜SD ñ,·¬` ÑÆd‚µ2q\=•Ó‡C›G©¿Ü'·r0K~+f]\0sÝ`Y›9VP®Û@ù®ÁNF»‰îäXßu“ÂôòfÉo]_“.éL¡Äj+טFS|¯îZ˜îšßàd´›èNÒô]7)Lnç7Q‚’lî”Ä[F` $ fë¿eKÎ™ØÆeÆq¯Áo Ó4ùm[Zk¡êJJcMâ òæ˜Hü))ú›]ŒvÝɱ¾ë&…é9ä7Lk~C.!gýŽò»1õW³X ñ1Ýö˜À%ä]Gw’¦ïºIar;¿ #QTØV^V;¿­+ä“{]FpÙù ³äw¤‚„dtuÕùݘ†“x’¼’;Œ@³“Ñn¢;9Öwݤ0=‡ü†Yò[„Eß|A®o~·¦ÇTþp*÷š™ë$ †/?z›4×= ºß6y 02eü6ÐIXáaƇ“>l 6É—á“—xqšü`²y »¥ •·¦Ñ$žˆoį+Ý^Ž]ŒvÝɱ¾ë… ŸC~ã,ùEßœXŒ©OåÓcz÷˜Çt—4ðåGw’¦ïºIar;¿Ñ™Gý ŠM²^DLH&Ù8}ËO%Íëá”ÙN²éê°0MËž$›ò®¿PäX]IiL#]ùkdº)à»–¼´LêèNŽõ]7)LÏ!¿q’üNY7`¨`GÿKML6¦!bzŸNëVîv5£/?º“4}×M “Ûùm;9Èv7C¶Š˜JÐ’”M÷[ÿäUÄT«Ù½gŠá£WRpšüFÖ-˜50r=Œ 1Ó÷db0ý…›»í:º“c}×M ÓsÈoœîüÖ…©èKõˆðÆ4â˜à}ó;[}“4W;wÝIš¾ë&…ÉíüF;î/ÇÅcLkBqÖŠ2s 1ræõ>¦Ñ9Š>J~ãôÀK݃p”Ô¨¤6¦bº@ !&ñÇÐëovM±¬£;9Öwݤ0=‡üÆYòÛví¤«lÂWƒÿOåjÓ1åü^Ítï ÓÉh7Ѥé»nR˜ÜÎo6À¤¥‰H2ª淮އ\¸ÝW,oz= bÜw.êö›Â4=ð’’véV©™]ؘF“xòûóxì{9vM±¬£;9Öwݤ0=‡üÆé—IbÔ×$Mc ¦Ê»‰ô›ö“†®)–uô6i®{&r;¿—b&N%-µ ا§h@tÙ‰^^ELú0é.P7Ó>8WîúzÆ9–l<FH6¿³ÚÊ5¦bÊ@L¯lðr,~ùÑë»îQ˜è9ä7MËž»ï¡Û%Ý|Uäwc &Ý¢¿“nºnzLèÒ2©£;IÓwݤ0¹ßÆÀdI¶!KrtQÜdƒ‹˜HÀ¦Âi…Á¼Œ˜ôa¶{r„Að“ß4K~K)–!Ø eÅ1Õ¦bùFLáŽc¢“Ñn¢;9Öwݤ0=‡ü¦ÙÎo0}wÉ¥Øø¹•«MÄ”É1±?‰W³³»‰î$Mßu“Âäv~ë†Jw ²J9Ö¦ “1tF^£nUÔ)¯NIa“üV¬Å‘e<”î7…izà¥5-êæ’õ+ͯÆ4œö ïS9› w“c×Ë:º“c}×M ÓsÈošÖü.©Èvu±TûÿÆ4BLá=ø5bÎw0ûò®£;IÓwݤ0¹ß¦¶RŽZ˜Žwi1q)˜(fã±W,míÏvˈ>©ÇDÓߙީ¥º\åZZ·6Sàkk ñV¾™®vî:º“c}×M ÓsÈoš$¿“¾7ZQŽK µº`c &)ïI¼Z˜ÂÝj–¿üèNÒô]7)L¾æw1Õ„ât—¶rgU£ÂZ†­|Yó;äTLµ²0Í’ßš ô[dƒ¾?¿Æ4BL!Ã1Ù…^?ÇNF»‰îäXßu“Âôò›fÉoPäÏ9êÞ«¾+W›ˆI—š7Çv¬ë& ŸŒv½Mšë…‰ÝÎo°ë3\Pw Çh¸Ä”Ðz$Lî_¡ïÒ0‚×ÃZØìçrÊŸDLí&º“c}×M ÓsÈožÖüÖ÷=s±4n4¿kÓ1|sLñö/_BÞut'iú®›&·óƒ ° 0­7+ˆ)ÇbÚ@ÄA_˜U=&}˜ô“Ê%K¥ûMaš–=aokŸ¥žÄÛ˜ˆ‰8_…ZÁM¸Cå—–IÝɱ¾ë&…é9ä7Ok~‡¤_I(’r¬®¤4¦!bÊ@LwÃåò®£·I3pÝ£0‰Ûù­¿­É Ý‘äÕ>¦0ƒ-ß%­žÊéÃRXÿ¡Vúd“Lw~k›×&¹’ÖiMÄ„–gŽ•ÛS9¹Ú¹ëèNŽõ]÷(Lòò[fÉoH„&R* X!¦Æ4@Lú2½5¿#Äp“4ðåGw’¦ïºIaò5¿#aÔM”¤¸W© €-ÉK[¹×ÃtWˆ ~’c’Yò»Û&¡¾ôº9­8¦Ú4@L˜Þ}L±ÜN{–“Ñn¢;9Öwݤ0=‡ü–YòuÇqÌ{…WíÕjÓ1aüžÄän+''£ÝDw’¦ïºIaò5¿£VýÅQ_Ÿ’Wû˜òqž—¢ô÷:Çd#ø²þ`ùh“L¼Ìí» )Õ…©1SŠï^¹’ð†ü–kŠeÝɱ¾ë&…é9ä·Ì’ß,!‘[Ø« –­i€˜@Þò?&}—4òåGw’¦ïºIar;¿ñ °)ÅRÖ“@¶Œ9Ä´&{òz8éʯ83|R]@¦Éo…#ö%;¨ÈïÚ4BLê÷FL(7M¼r1Úut'Çú®›¦çß2I~—Àº§NŠDl«ô#iZÓ1§òFLñ1½í6º“4}×M “Ûù 93{ %dZ"¿ ôÄ(¤{ ŠHk—x_3»-Gy,ù›Â4-{¢%D’ÂÈP·¤Ô¦bŠßê‡üMŽ]Z&ut'Çú®›¦çß2K~#›Ì¢Íº ÕV®6É{5 !Ý\âM'£ÝDo“fàºGaJ~çw‰ ñÈú$ó«õf1i)†1IAÆÕ>&}8Š~`€Æ7€Q˜Ò,ù­{J’¨ÈWÿ[-W›ˆ)þAW>ëy“c'£ÝDwr¬ïºGaJÏ!¿Ó4ùmCp@_ k®ÈïÚ4BLá}W®¤p´;G'i.F»Žî$Mßu“Âäw~›˜RŽÆ=’bÒ‡£H*œ]|roš&¿u[‰bÌuµ•kLCÄ”þ€˜èf+—.F»ŽîäXßu“Âôò;M“ßÑØSªSm ¦Hoíû¯ b^aºí:º“4}×M “¯ùmƒpƒ Á2—´Ô.`:‚90Y÷øâ]¹ãa ÉÄãGÕÒ,ùÍLĨ~ùݘFˆé÷1u³zW˜NF»‰îäXßu“Âôò;͒ߺªê2ÁºüT§ri€˜ì_çj– Ç»Ât2ÚMt'iú®›&_ó;Ø|·¤ÀI«õ*Ç6í2EÝÙ<ßEÄt<ŒA7rhŠÄŸ,L³äw(Ißù¤uú%†ó‡ÂÔ˜F“x’¼{åDß´¤¤“Ñn¢;9Öwݤ0=‡üNÓ߀…$Ýq@="¼6 Ó{æ—"¦cü¬W˜®vî:º“4}×M Ó]ç·Ø]5Ý“åīߥؠjÔofž@Í1éÃ&«&“þÉÎï4ÛùMúÍIоP}W®1&ñ°\R”XnN~Sùò£;9Öwݤ0=‡üNÓß Fuo#×ßµi„˜Ôñâ˜tãý”¯vî:z›4×= Sö;¿£þŤÚì Ö2bJº©‘pŽñ]CLI+9qŽÈUȳä7‡bWЋþNÕV®6 'ñà[WžMÔ-Lùd´›èNŽõ]÷(Lù9äwžx)¬¹Ÿ¬Í¸â˜jÓ1Åpñ!6j‘o Ó5ŲŽî$Mßu“Âäw~;ç1a×”¡UŽIë±¶YDLÇÃ6.”ϕ˳ä·Vf»”0–Ø ¦Ê4šÄ“þ8‰çîä7ã—Ýɱ¾ë&…é9äwž%¿ÅkÖW º’Ò˜«Y(ò昒bî›Ât2ÚMt'iú®›&·ó[7Q‰uæ¬JY*Lzlødˆ6¢h1éÃ)iÅlôÉS¹:¾Ïò‹ÂTfÉoPp…‰ŠÄTmåÓ Ç4ÞâÝ}Ìr2ÚMt'Çú®{¦òò»L¼Ô=pD»éV!¦Æ4ìc*—º€ºÞœÊ•kŠeÝIš¾ë&…Éíü¶µ×D©º²MZìüNº …ƒîçÂê\9{ø qs™±ò›Â4Ýùôeׂ)’r5ð²1tå±¼gÚ)ÚMaºÚ¹ëèNŽõ]7)LÏ!¿Ëtç7ç’ ™BTíiˆ˜Þ*ÇNâ¦0]íÜut'iú®›&¿ó›JÀcÒ‰Í_+˧rE÷ hW%ÖOå )^²^¦Oö1•iò›¨pÎ1ÀÏ“ßÖ4Ò•ÿÃ}LHáf+W.F»ŽîäXßu“Âôò»LËž›ŒDœˆKÍ1Õ¦á©\ºV3#¿ï¶r—–IÝIš¾ë&…Éïü6âÚš‰ôíIa¹© †TôYž¡¬9&}Ùö½ÊGÓ,ù-6v+[£iÀª05¦b ”Þˆ éF] œŒvÝɱ¾ë&…é9äw™%¿EßvŽ”­U¸ÚÊÕ¦á©Ü[m1'|­ôNÒœŒvÝIš¾ë&…Éïü¶™•¦\8¥¸ÚǤ»bÄ¢ˆ‹ò¢‚åñ0IŠÔâXÌé7…izàe²¾E1…¨Tñ˜i¤+/o‰©í¢_˜®)–ut'Çú®›¦çße’üN™uw±Âýs5kL#Ä”àºù™oS áËÞ$ÍÈu‹ÂÛ¯î@LÆ?ç¤V¶ÿºˆ˜*‘‰ýCŠ9-Ε;¶aQwôÁ­ÜùõŒs, ÃŒ„9TtAc!&xϕӪ[ü¤ûç/?º“c}×- S !¿ÏÏ{"i0ÚZÖïø5sâSm!¦ðVÙÈoú˜t ÿåGw’¦ïºIaò;¿sVD!hGc‰–ÚŽi™¢û8NPJŽK[¹óaý¸€P¢|°]àüzÆ9–R»¢QŒ…ü©ÇT›†³ ßœ[îÆ¾üèNŽõ]7)L!¿ÏÏ{œ4²“æ’Cæj+טú«™ zÍÂþó_ä *ÃÉh7Ѥé»nR˜|Íï”r*¨›P × îÄ„ÌIôeÑý\¢Õ»rÇâ+*ôIŽéüzÆ9–tKª¿•u}–ú®\c"&߈é¦ó[Áæ—Ýɱ¾ë&…é1ä÷ùy“&£­; `#©ÔS5+òºÇdv²Eû¦0]íÜut'iú®›&¿ó[l7‹¢ïŽ•ÕUÄ$ · p‰á¦UĤK¡TtŒßt~=ãK¦ïo#tÙ6¶bªM#Ž©¼‡3Øt+¿] †“Ñn¢;9Öwݤ0=†ü>?ïqÒdH!é*˵ìik &zÝü>åãŒÜ+L'£ÝDw’¦ïºIaò;¿Å†Êi¦—ã|n1‘þñ‰ìPO!×jç÷ñ°î!­õ >xWîüzÆ9– šêEÅcÖ¦ÑìÂß“xÀšxýÂt¶s7Ñë»nR˜C~ŸŸ÷8iŽa’RŒPêÂÔ˜ˆ)¼XÞñ5.¼Mšø‡)–?¢·I3pÝ£0E¿ó;é6Î:‰‰ã*ÇD *1†œW'ñXÛ8ó˜ úEaгä7ʬe 6cèkÓˆc ôÍ1Üßñd´›èNŽõ]÷(Lñ9äwœ$¿“MlSx,Y—çj|scê¯f™—1éB/¾‚¥V—/?º“4}×M “ßù]µ˜*v Ö&¹ˆ˜$E²½°¬*XGIÙT<>Z˜&ÉïRÄL&§]OI©M#ŽIò[]R¾á˜"~ùÑë»nR˜žC~ÇYò›¬Y¦ ›n}W®6õW³” /h éf+OF»‰î$Mßu“Âäw~]|C6•Ÿk/ô$›6ìrXj8Ö²FÙnð|r+§ÉïxÌT 96§ri„˜øÝ>ñšc見Ѯ£;9Öwݤ0=‡ü޳ä·nº PÆ(þìÊmMýÕÌ)Þˆ)Üö1Å“Ñn¢;IÓwݤ0ùß ²ÉGQ$Z’=1УX„S²ÉUK[¹ëáÌ”MÜàƒ—xϯgœcúõ1 “þ9TŸÊ5¦1Ç”¿9&ôÇ7)Nýò£;9Öwݤ0=‡üŽÓ/Mˆõ¸Œ^ª¹r­i€˜Ò·†¬ØrvS˜®)–ut'iú®›&¿ó›Ž³€CÝ`q/P‘ú,E›4¾Ì1évG÷# ¹¢|1Mk~gP(–Ÿ –­i€˜4ÞˆI»­Ü%ä]Gwr¬ïºIazù'ÉïS$›ÙbªŽr[Ó1é»ôFLÀå†c‚£ÝFo“fàºGa¿óŠˆþÎ)zM²ZêcÊAWލoÊx˜nÝǤ!HŠ>Údz²'1³yY°ZüZÓhvaþ>• nœZ&Mt'Çú®{&xù ³ßlÚQk ³T –©¿šedÌbâ7}Lp¶s7Ѥé»nR˜üÎ凞ɦzÐò$^@@ ¥DQ§²${òz´†zŸòIò¦5¿uCªûü@E1d…˜jÓhÚó÷ Ï’3û÷1#\BÞut'Çú®›¦çß0K~ÛíØLù^jÍïÆ48•#›óu"&]wnÚàd´›èNÒô]7)L~çw°Š|Lœ kã› ôŒÖ¸Mµl1™“äHL‚á¿)L³äw±Ó.Óž´éH? Sci~]Ãþü—¢Uänñ;í&º“c}×M ÓsÈo˜îüÎlRÌTïÿ[Ó1Ay_ jz“4W;wÝIš¾ë&…éFó› b›Þ¤Uu1q‚h"Ëßú0Š–5JðÉK¼0Ýù­Ÿ€¢iIåç}ÌÖ4Òü:%› 1™¾çMŽ]íÜut'Çú®›¦çß0ÛùM¶GÐf+þ,Li€˜ì‰ 1Å»Ât¶s7Ѥé»nR˜n4¿) E-’¹¬ª â%ýSmÈ'çam©;¿M‘ H}ËÊçÊ_ÏTŽi6¤¬ŸF@ªs¬2 ^šßvðæ¢8\Z&ut'Çú®›¦çß0Ýù­ß´ØrQt+V%MmÊñ{N‘Ä»I¼¯vî:z›4×= úßj`±N­LkÒº zôí`ȺÔê‚«ßöp̈ ò'Oåp–ü&ö¢ß š®gÅ1Õ¦ÇÞzL6oé†c“Ñn¢;9ÖwÝ£0ásÈoœ%¿uUÖ%Va1b¬V³Æ4êc¸“‚„èOI‰_~t'iú®›&·óû8ƒ\2$´Ê11™S)!ë¿WÕìáHº‰ Qƺ¼¿)L³ß𤤬¿Ú4BLòÍ1aN7'¿x¶s7Ñë»nR˜žC~ã´ìI´^"ê¾£¾Ä[›ˆ ‰/2…M^à&i.-“:º“4}×M “ßù­€µ}›¼=ðj“䬯 îÇñÜ[@Lö°nGÐôÉÂ4K~Û}¨ÛK-´5ÇÔ˜FSÆ÷©“ÜÐÈ_~t'Çú®›¦çß8/{’Ž¡±\ê»r­i€˜B¦KÉ‚›¤yk™TѤé»nR˜üÎïP€uã‰R¬ý{1%± o&§¸i•c:V¨fœð£…iZó[BN˜–ZZ§5 9¦sà¥qL’î¿KÈ»ŽîäXßu“Âôò§Éop“®\Ëž6¦þj¦)_Ѐõ•¼ƒÙ£]Gw’¦ïºIaò;¿£"¦lZ”«SR²ÝÞ%>æ È*b²‡]í_ŸÝÊÍv~cÒ|²îÅŸ…©1“¼Õ‚u+ïrìlçn¢;9Öwݤ0=‡üÆYòÛtŠ)ëΡ:•kLýÕLr8„óÄ„7…/?z›4×= Ýt~³èNLçP^}€Kˆ©$¦"ò’áXELúp …“µO"&š%¿=ý8(ÆFW¾1SHß³ õÿºÉ±“Ñn¢;9ÖwÝ£0ÑsÈoš%¿ÁZùu…çšünLÄ”£\o &¼Q “Ñn¢;IÓwݤ0ùßÐæÊ¡MR\VÈrHX¦ã4rµIŽ@9QÂOj~Ó´æ·ºB±w_·û? ScNâ÷ì”ÓÍÉ/]BÞut'Çú®›¦çß4K~+†0¹n6Zñ§º@m &}øBL¶ñºIš“Ñn¢;IÓwݤ0ùߤ˜Ñ~oÎׄâþlµ¥D*!ÙÁ^^’’Y /3|ÏÓº}ø7…iºót™²KÍFâü,Li4‰‡å˜LÙí&Ç®vî:º“c}×M ÓsÈoš%¿ueµ&| } ªÂÔ˜ˆ‰áÜÊ)b åî/ŒvÝIš¾ë&…éFó¨DÈÌú;/+X–‚¢/I( BXÚʽN‡JŒib²ó›fÉïÈÞyýt}© Sm!&yÿIYáóÝâw2ÚMt'Çú®›¦çß4M~ë R ú&…ZZ·6 ˆ\êdÀMÒ\ŒvÝIš¾ë&…Éïü¶¦bºX@‘§¤ ½ôZ—lhGXELÇɉ˄.ïo Ó,ùͦñÏI·JP«¤6¦áìÂpu~g£wtÁÉh7Ñë»nR˜žC~Ó4ù-¡ Iá+Ù“Ö4@LAÊu.N á1ñÅh×ÑÛ¤¸îQ˜ØïüÎIñ]@”;¿1äb ˜E+òâ$Þãaû°m}ò/ϒߢ»®hÂËäçâךFˆ ÞSRlrÞ bâ“Ñn¢;9ÖwÝ£0ñsÈož&¿‹¢c‹$)V/Ó18¯Ñ+b’‚7§r|1Úut'iú®›¦Íï˜S4ž)“¬ª `D1Ù“˜ËcuÜ1éÃd‡˜,e|Ñî7…ižü‚º¯Ý×VSc!¦(ñBLñö¢8¿í*º“c}×M ÓsÈož%¿Å4P_Ÿc-ªÓOS5ãLï†b¾ÛÊ1}ùѤé»nR˜üÎï\l01Ä’ÖÚ´ªéK¢r)ÇŒðEËãaFÝLçø:üXaš%¿ Ù4+ÝŒãÏ))­i0‰GqÍ{v¡ËÝäùÑë»nR˜žC~ó$ù’î‘D»ÑõjV›ú«ç\ðBLœòÍþŸåËî$Mßu“Âäw~ýw€”$ä,‹§rx\d"úî—ñ‰…˜ìaÓˆ5 Åñ´ì %Å!YÑH ÇÔ˜³ µÜ_9–J¼›öÌ—–IÝɱ¾ë&…é9ä7Ï’ßb ‹vÛ£¬®¤4¦b²Nå 1AÎ7G¹œ¿üèNÒô]7)L~çw*¨`ÉzBÞž“IƒÑT„%›»Ö`ùzØ@w=iÜ6þ›Â4Ýù­›K-²9p¤ê®\cM{r}˜úÁÝVîj箣;9Öwݤ0=‡üæYò›È”!ÉŽ8ê>¦Æ4@Lêwu~⺀œŒv½Mšë…IüÎoÖ¢bçbåPï^å˜Ø¤ñò$Áñ=Üšcâ,º.˜(c Ÿ<•“Yò[1\ÒW>‚4ÃÓ1¤+ÇÊÝ©œœŒvÝɱ¾ë…IžC~Ë´ì éwR¢ïR]˜*Ó1 ¾Õ%ßLI‘KˤŽî$Mßu“Âäw~묰%JiQ]íõ0 ;e“z]EL úSS`ÿ¤“Ì’ß”íŠN‚ŠcjL•TE4×g ±Ü¦“Ñn¢;9Öwݤ0=‡ü–Iò;™ +EÛ_K}bÒ˜Fˆ)ÅðFL‘nˆI¡/?º“4}×M “ßù­eIÁN‚Âñµ[☸°uºcÖÚ¶Š˜ôaÑõۈ飈i–ü6}’ƒ®+P UmM•ÔLñR°HàæJŠœŒvÝɱ¾ë&…é9ä·Lw~£þd”HŒ•º@c &LoÍo²ÍÈMÒ\íÜut'iú®›&¿ó¨¡ÄB1¶†˜õ”b“„À”F;˜Óâ$†>Y˜fÉoÄõ L±FИˆ)…ðVI-/òÎ˱“Ñn¢;9Öwݤ0=‡ü–iò;Yƒ0«æÊ7¦b‚Dï>¦äf_ŒvÝIš¾ë&…éFó$km¬›*YT@ÝŒå Y ÛšPÜëá¢ObÈòGÓôÀË hÚ¶µº9­&ñ6¦bÒ%êÊ1 7,rM±¬£;9Öwݤ0=‡ü–YòlöHÈ!ðÏ­\k!&|#&¸kH'£ÝDo“fàºGaJnç7覣Xiˆ&²Ê1YcDÀ@šØ;–mžn€?){’fÉï óŠšRqLi€˜LtáBLvÂr“cñËîäXßu”žC~§Yò[¬³èrQËž4¦bŠ™ù˜Â]ƒe:í&º“4}×M “¯ùµ%»§Sp©0½TætS¡oayLÕˆ q²P@Î ‹Ÿ*L³šßÁŽ#™|©PycM{NðFLŠ oÆ7¥SÈ»‰îäXßu“Âôò;Ív~Û¤{>¤¥Ks*W›ˆÉî@žo ærÇ1¥³»‰î$Mßu“Âäv~CÒOº¤gLB«ß Æu“ÀµÂôz¸—¿>){’fÉoÁR¶É-u޵¦®¼Ý!¼“M¢¹É±“Ñn¢;9Öwݤ0=‡üN³äwæ¤{ð¦?ù£05¦b 1\ê˜o5¿ÓÉh7Ѥé»nR˜ÜÎoE+R´!ŠºµZ嘢Iã'»¹lâ'«}L9DÝщX”üNÓšßú®'ÉÇÎúomMâ‰|ÊI8·¹NŽ]BÞut'Çú®›¦çßi–üÆhGû6ë¾&&[Ó1½÷ÿŠ˜n“æd´›èNÒô]7)Lnç7[’S^íü0©7­k y|«¤FLíP=#ëòôÉÎï4-{ R’èjõ“.hMÄdM§—æW9§S99vi™ÔÑë»nR˜žC~§Ù“”%³.±ÇT›ú«™îÏ3¾Ý¦ü­eò3z›4×= Sv;¿’ !`âSXœ’r ÙÈó¸<%ÅF¶YDð£…)Ï’ß)ýR +TÞšˆI þ{va"º¹’’ã—Ýɱ¾ë…)?‡üÎÓßÇ剈Œ±ÔSmê¯fV˜ä˜°Ü¦«»Žî$Mßu“Âäv~BJ…‚Vˆ’Ê’PÜqÝ€Á¤^3ÓÒ%Þ×ú*†hÿüdaš–=QgYBú?UaªMÄù ?YøNó+_Z&ut'Çú®›¦çßy–üÆ)è7’U²§­i„˜¯ÕÌÆÝ% }ùѤé»nR˜ÜÎo°!9K^¸eíTNK Ù&¦2¬-Í©œ" ŒbâßÕcÊÓšßhúkA¿BÎUSc ¦ÞŸz½»„¼ëèNŽõ]7)LÏ!¿ótç·nÛ)uDòÏ“Ö4@L)½÷ÿ(rw%%_íÜut'iú®›&·ó"q$̉‰^7'–:¿CF‰±äPˆWõ˜ôáãΘFÁ'§¤äiÙ-ÓD9óXu~7¦bÒšûFL7S¾´LêèNŽõ]7)LÏ!¿ó´æ·bG%H…˜Ó1Éká±æs¢›£Ü| y×Ѥé»nR˜ÜÎoÉ⢠峈˜tõÖ¿TK±X;ò"b²¥ŸøÇpë7…i–ü–|4±k‘-R!¦Æ4BL˜ß“ÜœüæòåGwr¬ïºIazù§eOô¥/!Ù)sÅ1Õ¦bÒ-ÿu.ŽúJÝ ¦ri™ÔÑÛ¤¸îQ˜Šßù‚.½‘Š êæÅI¼¨›±@÷­8.]â}=lS€s)Ì哈©Ì’ߤ¿cÎEJ©8¦Æ4šö\ÞêÌ·[¹¿üèNŽõ]÷(Lå9äw™%¿uÓ%ÇΘª>¦Æ4@Lü‚ÖÇšoðé&iNF»‰î$Mßu“Âäv~ëÿõw¶ÛÇ–õ˜0˜„ŒMoJ¹¬ª èÃŒvÉÎæð}´0MËžˆ®-Ö[¸¾+ט†Óžé{Ú3•›­\¹´LêèNŽõ]7)LÏ!¿Ë,ùõû 5¥èÆ¡ÚÊÕ¦b¢×Ñö 1…|³•+'£ÝDw’¦ïºIar;¿c¶CÁ´:%ÅŽûI^­0kÃ^Ûñe¡œÏ›ÔŸ*L³ä7æTl„§–ÚZ¾¹1 SÊðîcBH7מÊÉh7Ñë»nR˜žC~—Yò[@÷Iue—JÄ«5 ½¸Öך&t’æd´›èNÒô]7)Lnçw41%1M%(e1%<¡h‰Áå»r”r v\PRj¦ü¦0M’ßY;Á€œs¬XjÓ1QæëvÛfù&ÇÒ—Ýɱ¾ë&…é9äw™%¿u]›kZ‘ßi€˜€ß÷˜ô퀛»råd´›èNÒô]7)LnçwäE—‡8\昲•3bý@!¬ö1aÖO_·b*&!ÃZØ0.ß•ÃL(¶Â9¦óë™È1ý#(ˆ„ÌMoe &;©¼SÀèoå à—Ýɱ¾ë&…é1ä÷ùyÏ$M²‰cŽ5W…©1õW3]¢éÚÿƒ]¦¸Iš«»Žî$Mßu“Âäv~Û½bkp¶ñgK…ɺÀ1‘V¶Öµºˆ˜ôa Œºö³ð·rç×3Î1-ÍúÍ™<$aM~7¦bÒÏäÒüâx¶i99vi™ÔÑë»nR˜C~ŸŸ÷8iŽ;èÖóÊ”kò»1õW3Lßꂺ…Iw0[¾üèNÒô]7)L~ç7JÊ6‡—“èa1i9*ú(ÞR”¸Ê1÷]°é~.ÛÆS˜f;¿!ëÛž“þ)úyü,Li„˜âûâ¡`öO~!œíÜMt'Çú®›¦Çßçç=Nšlšòº­>ÖŠŸ«Yk ¦ôL<“Ö¥;˜}µs×Ѥé»nR˜|òl³ÍéL²T˜¬ ¥°þÝÖû½¶•;NZ’l’cú PÜùõŒsÌFw†HÑî)au%¥1 H|Ï.ÔÅïŽ.¸Ú¹ëèNŽõ]7)L!¿ÏÏ{œ4Å^øÀÙnÁWˆ©6 “ðûø Rº­ñò®£·I3pÝ£0E—ü¦lÛ¸Â&÷VŽÃÊ%Ä„ èS÷ ·Ê°¶Ôˆ õi&ëÈùƒÒºç×3αD3çh=é©îü®MĤôê½°Ø¿]ñj箣;9ÖwÝ£0Åçßq–üfÎ)ÙÝ›%ð³05¦bÒÅìÒc‚„ÙïÊ…x2ÚMt'iú®›&Ÿü ‹VÔøh½YALh1€)wÆ¥ñM¯‡Mú$Ù •ðÁ>¦óëçXÒM­DXêK¼µi ’j#).Ä$oè‚xi™ÔÑë»nR˜žC~ÇYò›£uk! ¹)Lµi€˜˜ß“mv‘ß` ñd´›èNÒô]7)L.ùõ¥1-&ÝËéöó:HšL|á… €ËsåìOb\¬>Y˜fÉo°vQHú-UWRÓ@%5Çwç71ð]ŽŒvÝɱ¾ë&…é9äwœ–=)68€Z=¦Æ4@LŠk¾S¼FñÒ2©£;IÓwݤ0¹äw¤BtñYŸÄlV•Ϩ;¿9X'*(¼LòQÄ4K~c£Û¬ƒ±šÄÓšˆIbzsL(Åo°„x2ÚMt'Çú®›¦çßqZó[tP读ìæT®6“pz#¦Âw[¹KÈ»Žî$Mßu“ÂäÊž˜0% %X½+%ÛmwIº9.«wåôá$vµJ„^â=¿žqŽ%ýc’~ÖÀPêËÚ4@LDñªòï8¦“Ñn¢;9Öwݤ0=‡üŽÓäw¶M’i÷èú\¦Ú4@L”Þ'& p×ü£]Go“fàºGa_öŽFu6 …M‹ˆIÿÎ ¬o!§Ä«êÑ|lšqŸl€iòû8AI!4²'µi€˜…^ –Ö9pƒ˜àb´ëèNŽõ]÷(Lðò¦;¿‹f°®CÄëÎïÚ4@L$DoÄtw àj箣;IÓwݤ0ù/Ù.8”ãdmu®\Hвþá”WS°éà%c¢"å“[9˜&¿L6+ÄÔ˜ˆ \ª{tÊìz9v1Úut'Çú®›¦çß0=ð2P.X8†RoLÄ„/áü11Üu~Ã5ŲŽî$Mßu“Ât3ðR7Pò¡~«“xuÕŽhCVì*îªæ·>̺‡4 «ôÉáç×3α$ù ó?J]˜Ó1Èu»à¸¥|“cW;wÝɱ¾ë&…é9ä7L“ßù§.vôU]âmLįé»bÒ…þæ(.F»Žî$Mßu“ÂäÊžèÞ3—ÀÁn¬g^DLP0"æBŽ–.ñ¾NAekïü(bš&¿…ô— B¦\‘ßµi€˜¬EûBLá,ÚNŽ]ŒvÝɱ¾ë&…é9ä7Ì’ßtiE¾ª ­i€˜LnñBL$7²§'£ÝDw’¦ïºIar;¿mº[Ç)•B²${rÀ-ˆ ¦Ü®;ÂEÄd³µ h5ÿðVn–ü6et“(U—x[Óh”·‚E¦]yÝ“}ùÑë»nR˜žC~Ã<ùôKÉ&k–ëÎïÚ4DL߈)Ý!&|3ÚUô6i®{&t;¿‘Ðrt;–çÊ«JTœe±óÛ; ÔíÉ'û˜p–ü!›\Í.lM‹ŒøÖüÒO÷æJ žŒvÝɱ¾ë… ŸC~ã,ùmLˆ®Bl—»~ž˜´¦b¢? &Ú7Is2ÚMt'iú®›&·óÅ6„Âúþ†EŽÉ÷Jak4ÐÝࢂ¥ÑîÖò%YËÓX—÷7…i–ü¶YéÖq›mÒÍÏÂÔ˜F“x ^ê(@7žŒvÝɱ¾ë&…é9ä7N“ß$ÖcH󬞒R›Fˆ)Rx#¦oNLðb´ëèNÒô]7)Lnç7>äít¿‘¥,·Os¤d‚Š‘ÖÚ^›6[·<oÿ¦0M’ß9¢)üa*6¡¡:ù­MÄ$‚ïÙ… mnN~‘¿üèNŽõ]7)LÏ!¿q–ü&#$JŒ6àûgaªMÄC|w~£â››¤9í&º“4}×M “Ûùm7ä#Ûäi¦Å¹r€%J2¼vg1™PS(!•ÏÞ•ÃYÍïéFcJ1ÿ̱Æ4@L)„ø˜î.Šã)äÝDwr¬ïºIazùóšß1¥™Ô§rµi€˜ôç¾û˜t[wÓ`‰o!ï*º“4}×M “ÛùMm¨\Ö_Êê”Å"ц|ê?0äÅ»rö0§høÕÇ?Y˜fÉoý^²µvIöçV®1¦=“¼URM5î&ÇNF»‰îäXßu“ÂôògÉoSø?4óK€j®\cê¯fÓ{‚…*Ý& _~ô6i®{&r;¿îØÛ‰ –+ˆ lTu$›YE«}Löp) H†ò—¿(L4M~“~Q¢Â‘Z] 1“ä÷©œ‚»É±‹Ñ®£;9ÖwÝ£0ÑsÈoš%¿ „XY“¹æ˜S5³·é­.Ê]W.ŒvÝIš¾ë&…Éíü&ÖFL@º™Kyµ)d»TÂPìzàjSÈ€HÖ?$’c¢Yò3fL6cïg޵¦Ñ´g¢7ÇD/"Ü˱“Ñn¢;9Öwݤ0=‡ü¦Iò;™øfIºÀ§Ÿˆ©5Sø˜âÝjF_~t'iú®›&·ó[‘f“‘ƲÚù –B)¤a‘cÒ(JH 2_ +L³ßÖˆÆ"shr¬6 §=ã…Ê‘2ÜœüÒÙÎÝDwr¬ïºIazùMÓšßM]:$Ý-Uíi€˜R„·‚å¡jã'Í%ä]Gw’¦ïºIar;¿Ib¤˜£Ø¨’°4ðò¸¹¥ÓÄñ NL`ú™4ö0’ JãøÉ>&šíüfìØK*=¦Æ4BL1Ê1I¼é•£³»‰îäXßu“Âôò›fÉo…Æ…K°{£ü³Ç¤5 “¼_kþíÌ/Ê_~t'iú®›&·ó›¨Ä`œd‘cŠŒ‘‚MÀÎ)Œ¯»UˆIÖR™ø£ä7Mk~sJúq(!©®¤4¦bÂ.uDÎ7ít y×Ñë»nR˜žC~Ó|ç7sÑÕ•õ5ªÇ7Õ¦b2eîó ŒÇºã& ¿Û¹«èmÒ \÷(Lìv~h‰ÂEÿÅ«ˆ ¬]%ÒÚ²4¾éx‚ îyl¦Ý' O“ßAW•’Aˆ%T…©6 ¾_Óž ݰðÅh×Ñë»îQ˜ø9ä7ϒߺ¼BЯDL­*Lµi€˜8¿»r£.>7û>í&º“4}×M “ÛùmK»þ;k]‰”õ˜b`…†’´#^œÄk—ù˜ÇûÑ+)<-{¢†bh]VB%FØšˆ .øi ½xGð¥eRGwr¬ïºIazùͳßR öÛSàúJJm &~ &k~–»Ñ:|¶s7Ѥé»nR˜ÜÎo‚\(–À)XOÑb2‘¸œc.’S‘…îL|=\ìž2Á«g£ûðo Ó,ùm£M Ò…%WWRÓ1…ò¾xh w9v2ÚMt'Çú®›¦çß„YK›.Ÿœ’’gÉoI‘ð&*XËž4¦bÂ|)Xè:x‹ÊOF»‰îäXßu“Âôò;Ok~««.Ív$•´nc ¦˜Þ]Ê‘K¸¹./!ï:º“4}×M “ßù6C S¡U¡8ý;l"êL‹#Âíá(l 1 š>É1åé—I¤º—b…ÊÓ1|ŸÊ!ÊÝâwM±¬£;9Öwݤ0=‡üÎÓšß&ÙÆaþ3iÓ1…œßßl:~Ò\BÞut'iú®›¦Íï`uEuÍtYä˜ "ˆ ‰ÏËÐóIcÛgÞT`8Éà7…i–üÆ*vÌÖAñ15¦bº&;b¢tW˜NF»‰îäXßu“Âôò;Ow~[g¿Ílúý,Li€˜Byë{DÆ;¯rµs×ÑÛ¤¸îQ˜Šßù}\W+ÅFy$Y¼+QJÝË¡î.p‰ü>ÎÉnïh%çüIiÝ2K~³(¸1òmögu*W™9VßÄrÓÇTâ—Ýɱ¾ë…©<‡ü.³ä7…ÇD1U}Li€˜"Ê[ó›åN󻜌vÝIš¾ë&…éFó; 5ÅèþS^ìc ’íXOw™–&ñ¾V¸•õÄŸ<•+“äwÀÀZkMõ :ùmLÃiÏoT®8Þå~ùÑë»nR˜žC~—iÙÝ^s)&ò^k~7¦bùæ˜ÂÝV®\Z&ut'iú®›&¿ó[?IÉ”G¥Õá‡@@$‚@8tR!&»dŒI Š/>Ù`YfÉïb÷<‹@¬4¿ZÓbº“Ö)'£ÝDwr¬ïºIazù]fÉo¶Ù&¥D“¯¯8¦ÆÔ_Íb¹®Ñ+b"æ›+)åd´›èNÒô]7)L~ç·þκ+°«ê%–…y¯Ë@ZÑìUQÄ´ØÇd‹î!™<ï'Éï2Ûù-ÇÔ› l­è?OåjÓ1xÏ•;.ûÜäØÙÎÝDwr¬ïºIazù]¦;¿é[†±°FP›ú«™¦÷¹¸¦»Ñ:åj箣;IÓwݤ0ùß$“V–Œi©0Ùe I9Xû7bNK“x_3}®kéý¦0Mk~Å" ¬‹jÍïÚ4@L¦½w!¦ñ.Ç.!ï:º“c}×M ÓsÈï2K~뺬06ÙCüf·¦Ñ©\x¯fÑdÎܤÁ¾üèMÒŒ\·(LØ~u/ŽI7r ¦ ’âZ»À1Ó8Ca£Í-ö1ÙÃÁúlvCü`a:¿žqŽ¥#ëŽ6J$ùÉ1µ¦AŽ¥?Ü• 9út†«»ŽîäXßu‹Â„á1ä÷ùy“æè¨Æ¨o| ðs5kM#Ĕқc²ãò›¤9í&º“4}×M “ßù¤€IQ“ ÛK‹ê† ô±1¾6“w1éÑJ*Éä?¸•;¿žqŽ%Ò2©›ËÒ¢òÖ4@LvWçBL!߈b8Û¹›èNŽõ]7)L!¿ÏÏ{œ4Ù®¡qB¶¯¥*LiÄ1}#¦ÈþþÃÕÎ]Gw’¦ïºIaò;¿uck…!'ÝßÂê©\.Z…M/Üú#–,ía»YAEì ‰?Øù}~=ãK,9'-Õúª‰·5œb„†˜ðFó[³åËîäXßu“Âôòûü¼ÇI“Ù–f}wô‹ê(·1¾W3»·š]ŒvÝIš¾ë&…Éïü(¦û­5¦ ¬žÊÙ'¹HÈúî­žÊYï”}ÉrÉiÈœÿ¦0M¼L1Û¨é+Xb8í&º“4}×M “ÛùmB™ RŠájVžNÇÁ4;CÓD?“Æý_}Óð‡ü©Â4M~§@úÝe݈W?ïqÒØ‘ؤ;jAk ¦œøÚ³D”›I¼ú®}ùÑÛ¤¸îQ˜¢Ûù)D­¤…u kã›ìFX´Š”õÕÀÃÉŸˆI¶îÊ‹Ýãùà•”óëç˜nŽ­K–J‚z|Sm!&x³²£ý»»„¼ëèNŽõ]÷(Lñ9äwœ—=Ñ…¹ØˆˆØ¦Ú4@LïÂdˆIâÍ©\|k™TѤé»nR˜ÜÎo$ÒM‡îªR‹wåÐ.ÙEÝ^”h¢L‹ˆIÆÂÌvYŽ>I~ÇéÎoÉÑD‚1Q}í©1&ñHzçX¹kâÅxµs×Ñë»nR˜žC~ÇYò;AdÉúÌϤiLÄ”Jxß•³áA7Is2ÚMt'iú®›&·óÛ¸!´“9(Äk[9=úŠD[úOXT°‡Mr%6YµO¦iÙ“ÌúýEý3Õ[¹Ú4šö,ù­’ZÂÝ©\¼´LêèNŽõ]7)LÏ!¿ã,ù ÇÐV)$ ¸ZÍjÓ1…³0b 7×0žŒvÝIš¾ë&…ÉíüÆ€$ÄhDVFÈ RLºr—”ôO_å˜ôa¦EZk¦ü¦0M“ß6ì<‹­-©j°lL#ÄDòæ˜r 7äw¼í:º“c}×M ÓsÈï8;ð²$FÑ…m éϤiL#ÄÄò>1ts‰ã9Ų‰î$Mßu“Âäv~Ã!—å^™ÀôšÄK‘"°‰Uk—x_GL(ZÖ¸|òT.Nk~[k•îî V9Ö˜Fˆ)÷Ê•x3¾I‘â—Ýɱ¾ë&…é9äwœ%¿!gNúDŽðs‚Ek &)åêʵö››¤“Ñn¢·I3pÝ£0Ûù )¥ ¢…”X`1q””)!dë’\DLú°î"µ @ù ´îùõŒs̶IVžuYºó»1 SúFLùîvÄ/?º“c}×= <‡ü†iò;Y"“¦r®&X´¦b²«]oÄðfÿ£]Gw’¦ïºIar;¿Y_›LTt7û˜ ÙÚH r^¼+g‡L˜^Ó?Y˜¦5¿û))1ÖcèkÓ1ÅøÎ±Ì7³ [ùÑë»nR˜žC~Ã,ùM’RQD¢/}­ÇÔ˜Fˆéj°Ô"óÍ0„“Ñn¢;IÓwݤ0¹ßv¬–sI hu/ŠñÖ º‰Í«ˆIJdkOù“Òºç×3αTÀZа(tÄj®\cM{|ëÊg€»»´LêèNŽõ]7)LÏ!¿a’üNÅšø‚q¬©>1iLÄÄå=Dw]p³åËî$Mßu“Âäv~ƒ§Q±Ù’hQ]@a¶«rI‹Ú9mv1ÊÒÊfý¨å³[¹YòÛDùEÖím-­[›Fˆ ¾O~³Ü¨ œŒvÝɱ¾ë&…é9ä7Ìv~³‚c6M3‚z+טˆé”ÿy!&wI“¿üèNÒô]7)Lnç7Dënºúb¼¨.€G_¥IžDL‹zLö0X‡¦iŸ„O¶ Àtç7dSY€¤L½•«M#Äé­’ªuäæv\íÜut'Çú®›¦çß0-{BB¢šünL#ÄDßzLv0ä' ^Z&uô6i®{&t;¿m:7‰.ïÙŽzVOå²Ö¤`×YLkn1é¿KbcM`<Éà… §ÉoÓúO‚ FJ­ÇT›ˆIwÈïÛ‰î^ŒvÝɱ¾ë… ŸC~ã,ù ¦ÝGtÜc¯ïÊÕ¦b‚oÄîî1áÉh7Ѥé»nR˜ÜÎocf£M`Íö÷îc2iô Qp˜µ¶Û§°8%ÅŽvdF6¿é“í8K~§Àl\~b¨¿Ö4@LšØïKwÃOF»‰îäXßu“ÂôòçeO e‚RB="¼6 •÷¹xÔ/øFößZ&Ut'iú®›&·ó;&ˆ¦†h'•1-Éžè1›¸-ÔˆÉTuëOOøIËóëçXJhý\Ñ.ï‡ 15¦Ñ´ç"ïÎoƒ„79v2ÚMt'Çú®›¦çß8-{’mm•ÂÑfçþä˜jÓ1Ù@ìk5S„s‡˜.-“:º“4}×M “ÛùY«)HH©$âÕS¹|Ì26¸šó2ǤØRBás-LÓߢï|¬…¶ºöÔšFÓž Þ½rÂñ®0]íÜut'Çú®›¦çß8­ù‹nÖA쀿Öü®M#ÄDßûÿ€é1]BÞut'iú®›&·óÛ–ý¥3£%Xå˜RV`@A8qÁ¥v×Ã6íJA“¾¸Ÿ$¿q–üN’ “*v¯¸ÞÊU¦Ñ´çòÝ+'ç6×ɱòåGwr¬ïºIazù³ä·~¹6JR7ÖYªñMi„˜è{ÿαCmÒÐÉh7ÑÛ¤¸îQ˜ÈíüÖMXAf#¯õ/Yå˜RÑšdqu'(«wå’ b»hx¬™ò‹ÂD³äwIúk±Ýt«,ÓhvaùbŠñ¦0Qüò£;9ÖwÝ£0ÑsÈoš&¿LRäfae &kÐ>ß@õx´8Is1Úut'iú®›&·ó;僻¦Bú_Ž^Ó›/Ô瘢]Ô²¢ŸhZæ˜"‡£WA¡òTŽæÉo›‹¤ÿ" ù]™FSŒßÐ *§7£]Ewr¬ïºIazùM³ä7 †Ì&ÅZi~7¦bBÄ«©p~MLq’†¾üèNÒô]7)L¾æ·î¦ÈZÈ4~ÂJa2Ð9EDŠ~ÒðVI˜ŒßÒ]µîãÒG9&š–=ÓbI6í¦îünL#Äħ´®ÑxùfD˜nŸ¿üèNŽõ]7)LÏ!¿i–üŽ&wDˆºRäŸß­i„˜/E´Âî ÓÉh7Ѥé»nR˜|ÍïŒA·Ì$4­pLQ2J.@2zjŽ)еÁ¸mü7…i’üÎAý4ôÅÿ™ciÄ1‘¼O~ùVó›^ŒvÝɱ¾ë&…é9ä7Mk~[ ‘˜(Ô0»5 p¸8¦¬+ýÝVîò®£;IÓwݤ0¹ä7‚ ¦"€*d1é6 LŸÀî¦Õ»r6¾×ÆäÛŸ|´0Mw~ǘts14 –•i„˜þpòËYî ÓÕÎ]Gwr¬ïºIazùM³ä·M¸W b 5ùݘˆ b¾V³¬_rð ŸŒv½Mšë…‰]ò[ë\„RZå˜$…T@‹K° ‹ˆÉdõ™1F i‚_&ž%¿1麢ÒÑbð³05¦bÒZÿ˜n,9~ùÑë»îQ˜ø9ä7O“ß ¥ˆæP+XÖ¦b¢œßˆ‰^pNÒ\ŒvÝIš¾ë&…É%¿íš\4BÄ.—ÃtWÖ*œôŸÖÈï×à /C Uæ~S˜¦ÉoE½ºñ2ÑöŠü®MÃiÏø=»Pî_ŒvÝɱ¾ë&…é9ä7Ï’ßC bäMÀ 15¦!bzß½PtÃrS˜èËî$Mßu“Âä’ß…ŠÝ”K¡à)M½‚˜Ø ‹Âœ˜'Pë1IH\€ì¸@>©.ÀÓä·‚›RŽqé©j°lL£Ù…¹¼,ôº#ä‹Ñ®£;9Öwݤ0=‡üæYòÛ^ bJºw¨NåÓ1Åל¯1‘ÜÊñÉh7Ѥé»nR˜\ò»RYPl,Ã2ÇD`Ó2cÊ™WOåôá`,®ØÑÜ',y¶ó;Ù•äR4¹¿ 1Õ¦ÑìBä·‚E¾ÛÊíÜMt'Çú®›¦çß<-{b¼ŠífVu‰·1 V³øº>q &xéy…éÒ2©£;IÓwݤ0¹²'ºõdÝH™–TÖ7h1Aa<îÿ&\º’òz8p ,¦žùÉK¼<­ùtSm¢d©ÛÓ1…ð=»0ç›&^¾„¼ëèNŽõ]7)LÏ!¿yzौ`’GUajL#ÄDåZÍ2¼k§0É5ŲŽÞ&ÍÀuÂ$®ìIɘR2ùÙ˜íüy 1é.…´¼°ãë%Ù“×á$Ýô2éoðÁÂ$ÓßÙY鯄ª­\cMâ‘ð>•ÓÊýÂ$W;wÝɱ¾ë…IžC~Ë,ù-‘¬YFßþ USc!¦ðî1I%²§^a:í&º“4}×M “+{RPÿ]J´¹—ñ¨-+ˆ) +<´I)4¤‰*Ĥ#ˆÉ2åÏnåd–üÖ­ ç%Ý`–º0զѴgõ#&¼x)øåGwr¬ïºIazù-Óߦ'¢™1æêoc¬f!ÇëÄDqq¸ÙÊÉÕÎ]Gw’¦ïºIareOr)/]\À’p©0…¿@ÖgéN¥ä(‹zLú°.$ú‰½Ú¤?V˜fÉoےꫯ»ÚR+X6¦bŠ!¾S¼-L'£ÝDwr¬ïºIazù-³ä·ØÜæ\t·Tµ 4¦Áj¾¯Ñ[Ëó ù-'£ÝDw’¦ïºIareOr–ì±d»ä·†˜À®È%» &Z^ïÊÙà ˜ Ûð§O¦iÍoÖ–$–ÂÕ}ÌÖ4š](åÍ1i ¾!¿åò®£;9Öwݤ0=‡ü–iÙ“À n².³R #hM#Ä”ðšÄ›„áŽcº´LêèNÒô]7)LnçwÆ„ +º~,k[9›ý„AØíÀ$²ØÇd!+R#ü¨´®L“ßȺ×BU˜ÓhOþžÄ oÚäb´ëèNŽõ]7)LÏ!¿eià¥f0G“v«ú˜*Ó1¥÷þ_ß§tƒ˜Ò§Xþ1z›4×= Sr;¿m:™ˆ)Ü2e\j°4ekݱ”œM‰*п®št%èÃ1}òT.͒߬56éª%öwÕ§r•i4»ßª{ DïÄSüò£;9ÖwÝ£0¥çßi’üN…ɦüQ¶N¡Š˜¬M#Ätµ è{© öMçw‚/?º“4}×M “Ûù­{±H¬›(FYº’b:ŠA÷r&C‰K…éxX7¡ëŽå“äwšîüŽQ1œ»˜\ ÅÕ¦bâü˜ßt~§«»ŽîäXßu“Âôò;Mw~ÛeOS`ÃÒ\I©M#Äá˜tëuÓù®vî:º“4}×M “?ðRË ›"Š fXDL¯ÖmÑ⸶Tˆ)˜t% ÑZ>Y˜fÉoD6‰(; (Õ•”Æ4BL”ÞzL±ÈSâ/?º“c}×M ÓsÈï4­ù­ù¥ÉOb³ªS¹Ú4BL/­œd2b7…éò®£;IÓwݤ0¹ßúÒ0kšë¦êäh§eOŒhuÉ®HP¬ýLkɱ H7×EL³ä72’0p¨¶ri4‰G«î…˜"á͈ðt2ÚMt'Çú®›¦çßi–ü¦&þZtq•‚ec!¦ðžì¨x!ñMa:í&º“4}×M “¯ù#ˆÖ¤˜8á"bŠZÒX’ݤ‘–®¤¼ŽÖfeV uaªMÄD¯!—övˆâ››>¦|1Úut'iú®›&·ó‚æˆl¨UZCLEBY²c¾®ùL&>Œ†+˜‘)‡Ñÿ)LÓ²'hÂuIk¬¾÷? ScMâÉ߈)$¸écÊ—–IÝɱ¾ë&…é9äwž%¿5{£ èÆÁvï?/ñÖ¦b9F6ˆI+É‚e>í&º“4}×M “ÛùÍV•[”— “n„KÔŠ–ˆY´6-&{8èÏ<–?Y˜¦;¿C‰Ç-7õ$ÞÆ4š]ÈòÖc²+J7…éj箣;9Öwݤ0=‡üÎóä7Ù¤[;ÇŠcjLÄ)É…˜8•›K¼ùÍhWѤé»nR˜üÎï$Ån¤p,¦B¹†˜„ìön‘Rt_!e 1 …‚Gaâñ£…iZó°ˆî,í¾G;%å§i„˜|Ï.|Myð Ó%ä]Gwr¬ïºIazùçÉo‘’ ãTäwe ¦øšôBLáN(®¼í*z›4×= SqÉïvïX"èî3¦ÅI¼l%­›4haîÆ~"&}X‹!Ø…9ÝÌ áÖ/ S™–=±}¥îLQw¨ÇÔ˜Fˆ)„wSˆw#ÂË¥eRGwr¬ïºGa*Ï!¿Ë,ùm*윳”j®|kê¯f9Ñ9@MS,|Ã1•“Ñn¢;IÓwݤ0¹äwÔí”›fD‘°8‰—ƒõ‚N8=?“†$†ÌT°äôIŽ©Ì’ß¢0 "DªXZÓhvá‹Ï?fæ 7· ÊÉh7Ñë»nR˜žC~—iò»°d@чRµ•kLýÕLw/o2E®‰©NÒ\ŒvÝIš¾ë&…ÉíüÖ¢Rµš²kþkˆÉ85Œ¤È'ä‹*N²™ÅÂú“ñ£…i’ü6©’ì–’Ø(9Ö˜F³ ù]¨‹ˆÜ䨋Ñn£;9Öwݤ0=‡ü.Óä7[ʘ³ÍúùI~צbÂt^£×ý„݈¸Iš‹Ñ®£;IÓwݤ0Ýt~E{Loå ˆnç’â bNxP/ èò8ŒÃù,¿)L³ß¤{$Ö?Fÿ¤Xõ15¦!bâ÷©\"öé g;wÝɱ¾ë&…é1ä÷ùy“& ØtŦ)ZÁìÆÔ_ͤ@¹¨é>æ6i.!ï:º“4}×M “Ûù Šv'2)Sha>iâÑ8Ÿ$€µ ,’ßѾbÚ(ôÁ>¦óëçX Z,£dý…ê»rµi4í¹¼[³ FôoPx·sWÑë»nR˜C~ŸŸ÷8i2(Ð)ŒúÚ×§rµ©¿š)Îb¢7ä7…‹Ñ®£;IÓwݤ0¹ßl®R¶ê°Ú.\ˆ šFÁÚ©œ=Œ¦èE]û‡ÿ¦0Í’ß9A¶ûJvݱV¨MÄt^Ñùó_lÌy2ÚMt'Çú®›¦Çßçç=Nš$ÚŒ[EÈXoåÓ1i]º8&JpÓüFñj箣·I3pÝ£0E_öÄîﻎ‚VÖ^/Cf›®¢”xn½^F¶Ùr!#†O^I9¿žqŽ%›ÈÀb³*rÕÄÛšFˆ‰¿Oåô¾)Lñlçn¢;9ÖwÝ£0Åçßq–üF[ÛψºVÔˆ©2 âû®Ñkr—4ðåGw’¦ïºIar;¿Á&N§‹èNnÜ]5XêkbÒ—b¢eË –É<駃¤O¦Yò;+€Q¿½`]Y?Sm"&üFL@7¨<žŒvÝɱ¾ë&…é9äwœ$¿‹}ÕÙÚ3ÃOb²5 S`ysLð’¤ð’æÅh·Ñ¤é»nR˜|ÍoE<"&óh¢ÿºº’¬+KbN²({B`Šú¹`ÛÎ}²0Í’ß ðÙdïl¢TÅ15¦Ñ´çüÖcÊt»•‹'£ÝDwr¬ïºIazùgÉïÈ1çl PMIiMÄ)Ç7b¹[ÍNF»‰î$Mßu“Âäv~ƒ‘CBB©ä8VEú‰˜H‚þ­hCVÒBw&¾Öz¤Õ\´6Ñ;¿Ï¯gœc©°‚Fä¬Úþ,Li€˜"´™"¦øÒ,örìd´›èNŽõ]7)LÏ!¿ã,ùÍ|¼ðÑnªS¹ÆÔ_͸`|#&“¸Iš“Ñn¢;IÓwݤ0Ýt~ëN,î HKÄpCõ3iLT€ ‹Évóªì‰>lÃÉ "ÅÝÊMw~G„ÙŠt-­Û˜Fˆ ÞŸ‡fØíVîj箣;9Öwݤ0=‡ü޳äw¶mƒd*õ©\cê¯fœ ¼9¦ãMœŒv½Mšë… ÜÎoÓÑÐ¥7Hκ§Z•=!Vô‰ ˜ ÑJ¾ÖWVw&œ Ç^â=¿žqŽ™Ì?!s? ScMâÉñ=í9Ý’ßp2ÚMt'Çú®{&xù Óß…Že=7“xkÓ1%¡ë…󂘓4W;wÝIš¾ë&…ÉíüŽ4Ïc21ÉWS!²‰è6O7äUÄT8J’m¸à¸ƒê7…i–ü.™Ñ “Mº©¶rµi8íù­ÇdógnXàd´›èNŽõ]7)LÏ!¿a^óA¿a»)TojLÄtÊžGCY7“7Ióò®¢;IÓwݤ0¹ßÝ ˜e:U†ç“.Ü)FÖe1éê’ŠþX­KôÁK¼ç×3αd7dõËËšPqLi„˜^wå’¤|W˜NF»‰îäXßu“Âôò¦;¿SÖ,Æ)òÏ£ÜÖ4@LÖ§|"&¹]Í®vî:º“4}×M “Ûù­h瘞(¹˜"ðü­’CZWŠÝß%ëxÏkä÷ñ°é ê;Æmã¿)L³äwRè¨Ûp»‹V Å5¦bÂr}Éô¦nr,}ùÑë»nR˜žC~ÃtçwT(Rtõ3åûŸ…©1 S ñ˜ø5~ÖKš«»Žî$Mßu“Âäv~s¶X唀hi®œÍ1N€®àExaˆ¯‡³~xÆSÍÈ_þ¦0Mk~s2qäc¸pÍ1Õ¦byO{FÄ;T~ y×Ñë»nR˜žC~ôìI‚ÀöToªMýÕŒJ„ë D­!7«^Z&uô6i®{&ô;¿ µ*Yÿ•É ¯ÒþLš¬óÂ.ÚéV.-Jëæ ?9"EO.ŸÜÊá,ùmxÄNTâÄŸ –­i8í9]…:ÙÜ€›;í&º“c}×= >‡üÆYòÛ„ïãq®týl¨MýÕŒ2•r!&;ª¾Iš“Ñn¢;IÓwݤ0¹ä·æ¸~ *ù¼6T /³Ø†"™&“‘àkˆ)§%§d­ò™>Ù.€³ä7뼘’@˜Ó`¿&£¼fêƒ79v2ÚMt'Çú®›¦çß8K~Ûõw´©úòײ§µi€˜t͹DÍ9ݦ“Ñn¢;IÓwݤ0¹ä·î>C´)Ú1ÛùØbRd˜@l˜@i,Bù3itówhÄè.òGû˜pZöD1¯µf!ëæögajLƒIE¹¹]€—–IÝɱ¾ë&…é9ä7Βߦ¤‹kIEWŒj+W›ˆI·×j†÷Bqx2ÚMt'iú®›&—ü¶þk–P²ø¬qLÖAìš,½z VF„þTÑÅyôðo Ó4ùÙ”´00V‹_k ¦÷‡i³ )Ý!¦‹Ñ®£;9Öwݤ0=‡üÆYò[¢©™Ù´ŠünLÄ„ßo †tË1ŒvÝIš¾ë&…É'¿Ñ„$é¯l#ËÖ“Ö#!ÇD×µ‹éÂt<œBÆB`2¢ñ“…išü¶")löçOò»6 tåóKý@LäçØÅh×Ñë»nR˜žC~ã,ùB¶_Œ¹ÖünLÄtžNˆ)Ü &:í&z›4×= ¹ä7gd“E2áïd»_ˆI÷`džLÏK…éxí¨ @(áØ~ª0Ñ,ùm—‰õÏ ![†ü(Li0‰G$]<¦Ät'­K'£ÝDwr¬ïºGa¢çß4K~GæÅÔÅrªg~Õ¦b‚’ß}Lá?ë$ |ùѤé»nR˜\Ù9DGln¶.øEÄdÛ1Ðm ØÅ”án¬BLѦ6H&~>Z˜&Éï 6Èʸe¢fàEm &k§??LÖ}ÝÍVŽðËîäXßu“Âôò›fÉo›ˆ9Z+G˜*S5S,,×”°Kõ7IC_~t'iú®›&WöD2Ø‘¿UŽg•Tˆ)¦bã`¹‡Dñ bŠY?:»\ô¿Ò' Ó,ù-™ã!AªûËz+W›F³ ¯“»4.wßÄ_~t'Çú®›¦çß4K~Àñ?ÅT\¦ÆÔ_ÍP—³ëÄìòêMÒœŒvÝIš¾ë&…É•=‘€ °UXÈ”(“îÄP XFL¶±M$LT¿)LÓšßZ&CÝ+ÙˆŠ…©1 S|]â=S†»Kº„¼ëèNŽõ]7)LÏ!¿i–ü¦s)ƒµGþ,Lµi€˜çkÿ‚é1ŒvÝIš¾ë&…É•=±½§ ã&’\>•SÄ(™’0D‚ž1¥’lØG›aüÉÂ4K~›šfÖÍeÒ? ScÍ.$¹Nå˜3ÞåXùò£;9Öwݤ0=‡ü¦éÎoÐEÝî íÏým &º.…¾7ä7_íÜuô6i®{&veOкIg(ɤ‰Ö(ÀhºÝEp©]àõ°ØõBÝêòÿÁÂÄÓšß²I¼Y#Z­ÇT›³ …ß<&›FÉMŽ]BÞut'Çú®{&~ùÍÓ²'º¾J† ø?ÖWRjÓ1Ñ5øÕndßÀl¾´LêèNÒô]7)L¾ì r(ŠXŽ?—.ñè ˜È¦UYiZEL!궗ΜãÎÆÇ Ó´ìI² SaãjDXk &u}sLºÞ´¤ð¥eRGwr¬ïºIazùͳ䷂mßm.ãÏ+)µi€˜ áÅò ¼¤9í&º“4}×M “K~›T¿®î™mŠSù÷ô1Sr"šùïèc›„`XÕ~S˜¦ÉïxÌE)©ÖcjLÄD1^UÞÔ]nÚøb´ëèNŽõ]7)LÏ!¿y–ü¶{û…ÙÈåuaªLĤKÎ¥ùm7ŽndOY¾üèNÒô]7)L.ùMšâvƒ7RK[9›1@Ä0"ê_¾¨. K¿n)–lÇŸT°äIò;ëŸE·–´ü̱Æ4šöŒñBåDî¿ôåGwr¬ïºIazùÍ“äw*¢û¤KÿϹr­i€˜¼OLÀNöo’&ùѤé»nR˜\ò[7Q&Ù I@·²†˜ 2Ì)fX¼+‡\Ðf“g»•òIKžÖüÖo0¥œÃA•ci€˜ì á…˜¢ÜMâáKÈ»ŽîäXßu“Âôò›gÉoNúÓÕ¢º.Кú«(@¸ô˜ba¸ALr2ÚMô6i®{&qÉo»å†¦JÍúeiàåŸÿ¢Q?@ý‹3–$ÃA'•º€èG— ¨däôÉ))2I~çPH¿À¬¯«ºöÔ˜ˆ)0}#¦îr,~ùÑë»îQ˜ä9ä·Lw~‹©=PÈ!Õ“xS5 éBL&‡{C~ËÕÎ]Gw’¦ïºIaòÉoÅŒ6Á %ènnA÷Ðc­Ä Ëwæ±e¥Ç º1IsÉi(þ›Â4-{R’Ögý8—ŠünLÄã7b |§`)—–IÝɱ¾ë&…é9ä·Ì’ßF†@"@©g~µ¦b"xŸ˜ÄôR³ô’æd´›èNÒô]7)L7šß‚œYâhÚÝkˆÉ¶Q8ÚȪ"‹šßɆ“CS˜˜Ïò›Â4M~£~1B1—Šü®MƒÙ…9ÅKÁ‚òíø&¹í:º“c}×M ÓsÈo™–=Q‹‚ºiȵSc &]á/2%P¸IšKˤŽî$Mßu“ÂäÊžD$ë7«ÐE–¶r6ÿÃö­º¦"‹ˆ))LÓ}tÊ’t?ùQÄ4Ûùl”ˆi–ÔBqi0í9…üžÄ£ðÝâw¶s7Ñë»nR˜žC~Ë´ìI,6ËÚô!C¥ÇÔ˜ˆ)¸V3»¨}s”+—–IÝIš¾ë&…É•=±³¸d§cŠ_çÊiU2uFA4‘ÝUÄd÷\¥¼,ËG Ó,ù]Š‚7]«ô{¬PykM{FzÏ.4 …›;í&º“c}×M ÓsÈo™ïü¶SWHH*Ž©1 S ¸ºrMtü1¥w;w½Mšë…)¹²'‘¹@¶±rµT¬"&}E’þÉ%ÙÇ°Š˜t§vއ›È_¦4=ðR!“`É¥ÞÊÕ¦bŒ×ÅCÒO–nrìšbYGwr¬ïºGaJÏ!¿Ó$ùmz?vqÑ6ÙòóSkL°È/q¸1Ù¬¥›¤y1Úmt'iú®›&Wö$r¶Â õ9jY]xim„hsa“–%ý^DLdô‚)`Æ< ÿMaš%¿¥Ø]5˜b%­Û˜“x2¾ïÊ‘nïoPy:í&º“c}×M ÓsÈï4K~ë.)JH%”ŠcjLƒ 9¤«+×ÚžoNLÒÉh7Ѥé»nR˜üÎïc°[‰ºÕ”_¦ûBLZlœC´§˜óbÒí0„ù“SRÒ4ùm¢ÈºTázJJcM{Æ·æ7…Û+)éb´ëèNŽõ]7)LÏ!¿ÓôÀK&kÊúúp-­[›ˆI(½Sä;ò;]S,ëèNÒô]7)Lnç·nåbÖ}A,”íòÕb²á‹†H.1.&{$D2®ÿ Ÿœ+—fÉïœL3èß+ͯÖ4@LàêcÂ\î„âÒÉh7Ñë»nR˜žC~§iÙ“lÇÒŨҟ…©1 “¾ŠïS¹ ·[¹KˤŽî$Mßu“Âäv~GÝ{R ZŸ:†šè5WŽ‚¦¢˜¤Àú\9²¢€ -LÓšß%H>´‚S…Ê[Ó1a¢÷$žøævA*_~t'Çú®›¦çßi–ü]VMèߎ*ò»1 æ·SIñ…žÚ¤ÉáËÞ&ÍÀu”ýÎoº!u Nqå`íèü°¿÷èù‹°Àœßp°S%I‚>I~çiòCN%e­$±ÒcjL£iÏ„*G¡xC~ç‹Ñ®£;9ÖwÝ£0åçßy¶ó›PвØ|Å 1Õ¦b2=Ýs5˺_§›Ât¶s7Ѥé»nR˜ÜÎ¤@ òBBXÄ+@`›aáøF[ALúŠIb2±"-L³ä·n”JÔr™ÊU§ri4íù¥Ou &Ò»)L'£ÝDwr¬ïºIazùgÉo0ÂR$¨µrZÓ1ÙÈÜs5³éù¦0ŒvÝIš¾ë&…ÉíüfÝ…¡þË 4­ê1• ßŸÕáX2‡EŽ©ÛõR¶û……>yW.O“ߺ¢°nÃíò^½•«MƒI<ú‘¼9&¤pÓ`™/F»ŽîäXßu“Âôò;O“ß9höëל+IŠÆ4š+Oùê1IˆrW˜.F»Žî$Mßu“Âäv~kQ(´Q ‹ˆ©îR¢I—ÄËêºâ'Å[R>ßÜO¦Yò[ëÞRk5C3Œ 6 kÈ BéÙ“|2ÚMt'Çú®›¦çßy–ü†BrȦ³QqLi0%•^0›lHˆÄãJ½W˜NF»‰î$Mßu“Âäv~çÌ6EK“þçqs‚æS &mE”ˆÇ"”•‚¥>\lJŠÖrŽŸœÄ›'Éok~ÇQ·IµSm &Û_ˆ)âÝ0‚\¾üèNŽõ]7)LÏ!¿ó$ùô…¦rªšßÓàæw惘´7©¼ŽuÛ¤)áËÞ&ÍÀuÂT|ò›m€˜&pZÔc²»¤,Šy‚”ÕI¼F}\¿Ž˜>©ù]¦ÉoÅŒE7ä •ºš’Ò˜ˆÉÎ߈IèæT®\ŒvÝɱ¾ë…©<‡ü.³ä7êþH éÈõ\¹Ú4¸Ç„t‘tÜcB¹9•+'£ÝDw’¦ïºIarÉoSÖÕWð’ ¬qLÑä'%èF,#¤eÍïR"ǤÏ£6?V˜fÉo]² ¤P_âmL£iÏ€Wç7¾›]XNF»‰îäXßu“Âôò»Ì’ߺéýŠ­IXªñMixb’ùDLHéuÙÒIúò£;IÓwݤ0¹ä·è&,2IÄCYÄ ÖþDºµ`-PK㛎‡‘LÃ*DüìÀË2K~§¨/}<Æo×§ricóõaBy}6^a:í&º“c}×M ÓsÈï2=ðR÷\€6öµÔã›Óh®\Œr"&àÂw[¹kŠeÝIš¾ë&…É%¿“•­)ã"bBÈZ’ì&4–å))º!+⢔áßߦYòÛh¶h[%Ý'U…©1¦=§ôÖ•Ïî ÓÉh7Ñë»nR˜žC~—Yò;}B!ýŸ…©1 ÔNí{CLúJä;Ät2ÚMt'iú®›&Ÿü0ém»¶J\å˜)ÌZéõ?V§¤èvWwòd¢¦ÙÎoE9CÛn¼ÚÊ5¦®|‚ò=íùv¨j9Û¹›èNŽõ]7)LÏ!¿Ë´æ·é¿ˆ¥ÖcjLƒ>&x)XÒ¡Z Tj’FÁò—½Iš‘ë…‰Û¯ÎSáX´2%ý 8È2bÌ&Ü©Ë7Äam©“hº2„òºåÚ}øIs~Þã¤I6åOëBd Õ1[k #,éj~ÓºpsÁ’Ã5–²Žî$MßõÿÒJóÿù—<*þÿøoÿË_ÿôÿøO=þþ»ÊÿïzæõÐÿü/ûßþzüúÛ?üéÿÇù×Ó%æ¿ýëþ׿þ·ãùÿú·úÏÿòÿ瑹úûü—ÓùÊXò·¿û;{ðúýÇ¿þßþ§¯?ýø×ÿó¿üñÿõ?éŸü—?ýWýÅþ¢Ÿ€ùÿÝÿúÿ)þ§øõ§ÿüÏoÎ×ÿý^/Åëÿôçc [6Ü<þ?%éNòÊ„ú_>rÌõÌÎwD8lÞ@ ãµæ˜ã }ñtÛpþ /¢ý¨ó¿ÅwD<#F0mÆ£è¾~kÈšS%ÿ'"p~G,ïˆtFéWbw9m!’ŠýkL£I‚ñüQ·x“4ôåGw’¦ïºIarÏäÉ8§,\l¸SYb˜«V&åu$kI£ûÝ…Ø~,ówËßíÿ)L³gò¤(…9D›&÷#ÇSñËÖ£yrSºÑ>$°¼;Ú›èNŽõ]7)LO9“¿>ïqÒèÎ(™ …ÝÃáê cM• …ÎÕ å54ÔKšó ½‰î$Mßu“ÂäžÉÊZX2ØÕ ]%Ö“n:Œyâµ*¯$ýd»[õ³ŠÇÝ¿)L³gòIÿýæX cÕÂߘÂڜË¢3YÒ$p“cçA{Ýɱ¾ë&…é)gò×ç=NšL‘sI)°H¨Ú«Ófçˆ)cN7IsI¬ÕѤé»nR˜üQ$(”!‹è¶*¢L$°öÚ”%,‹ˆÉä¦é.0çüêqÿÌMÙëëç˜Mí5 tŸ«“²Æ4=úCc¦nvù®0íMt'Çú®›¦§œÉ_Ÿ÷8i2êwAŸR­ÆÖ˜Ç«!Ä‹cÂlÒܤ‰áËÞ&ÍÀuÂÝ3ùh·›Å X‘ …Ãk/Šþýl버˜ì ôqkQÈöÁÂgðíÎ0°Ö›–Y¦Ú4h¯å¸Âo1à»;Ïå›èNŽõ]÷(Lñ¿o¢ýGÒL«±Q[@R­ÆV›f1_ˆ© ”›¤¹$ÖêèNÒô]7)Lî(›Pxà%E?‹¢G •©€ P;ª_K›tWôý±˜ã·rqöBZÖ·]_|ý©æ1Ó€.0e„1éVõ8 órì¼eÖDwr¬ïºIazù§çp3&}ãs ûY˜jÓ1Ar!&Ýy囤¹†k×Ѥé»nR˜\òRŒZQR ),ŠA(ÅæB뾂)䵤#KÈxs-o!}²0Í’ß9 ZCf¬e"Ó@XË4/Ä_øÙË1þò£;9Öwݤ0=‡üŽÓÒ’DÐW>Æ’RU˜jÓ1!Àõ‘½7IsÝ2«£;IÓwݤ0ÝÌáEì*Ù\쥭ܟ­9¯Ð1CòJÒ¼ææ•˜M.¾šÆ>¶•›EëF2Å¢XoåjÓ`ñ³±4矤h2ßmå®ù"ut'Çú®›¦çßq~IÈ ÀúŸUÒ´¦Q ¿É޽Åï`ö{¾HÝIš¾ë&…É%¿çp'2ÑÒTÉë/V¬dÒe1Y{è>ŽâqLúÁÂ4K~Ûº¢HG²D®ÿÓ ]€uo|üIŠ˜ŒÔ¼É±òåGwr¬ïºIazù§Éï"¢[¶A Õ…´Æ4@LÖ…}!&EÄ7… .F»ŽÞ&ÍÀuÂ.ùlóÀbÎøYEbzE¨•-ÉK¬| 1!ƒ"%›F™K—Ä_&˜Vcã6°I+f®ÕØjÓàä7ê’{qLºO¾ALpI¬ÕÑë»îQ˜à9ä7L«±êf=–Pð¸âòÇÂT›FÚ"pµŠ˜ Ç»¤¹$ÖêèNÒô]7)L.ùM\ ËÃl|Ï"b²ãGý£ ú”óRÏ|ƒ%Û¸Ð¥Éæ }NXûúzÆ9–ôsÐ*º·”\«±Õ¦AŽéê—/މ0Þ4ñÂ%±VGwr¬ïºIazù ÓäwJsLl“3jŽ©2 S~É^ˆ ñn+£]Gw’¦ïºIarçpó1‹Dg- ó×ÄĨÕ%J‰Z[â"Çdó4Ž:nÒᣈišüÖm’ "¸MSm)þÛµ§1QÆ›Îo¸í:º“c}×M ÓsÈo˜&¿‘áêLjò»6”²ÞˆÉúo’æb´ëèNÒô]7)Lîn±ÙH1ŠéB^å˜ÈîFÔš–Cµ¤ÑŸœ²m¥Y÷ta¸‰üMašîü6!½”²bª9¦Ú4h°Ì¯}ñ˜øÇ­¶9vµs×Ñë»nR˜žC~Ã,ù­[†hWQJ=Ф1šß2_«;QÊ7Ä$œŒvÝIš¾ë&…ÉÃêP’`Û9^>•S¨eÇrŠ›¨¬u~?™Jb£¿õSûdç7LÏáÎAk$M"ªÚÓ`ªD|¸9“)¹ßäØ5\»ŽîäXßu“ÂôòfÉo}‚iä® Sc¨±«oºÓ]»žŒv½Mšë… ò;ü%cˆÆÕÛ•9¦ÅÎmÕݰþGz)ö.$þdS@::™?¹•ÃYòû·;غKª/Š×¦Á©ṕSĤ{ä›&^<í&º“c}×= >‡üÆYòÛDœl–§X‰·¦bB|ß„×oùvÝIš¾ë&…É•=)ŠY"Ò_~&<í&º“4}×M “ßù(ha2ÑÄ€y8B­BL²]K!Rȵv%åøÉ1X›A)!Áçÿ¯¯gœcÆ*G;¼ˆ¡&¿kÓàJ \Bq¯I7 x1Úut'Çú®›¦çß8Ýùl8šP‰±ÞÖ˜ˆI/uÒ=ûbºÚ¹ëèNÒô]7)L¾ìIÐ×F×_Å=º—[í?S6ùp…ˆŠœ9&ûÉÅ>®’#†á€¥ß¦Yò»XW•Ml°ùh? Sc &|]?SIw½rx2ÚMt'Çú®›¦çß8Ýù}07`ªöP]âmLÄ” _Í€” Þ$ ]íÜuô6i®{&òeOŒK"6u>‡´ˆ˜5%ë„J¶}]DLú“3CÖêÆÃQ$¿(L4-{˜“¾úEÖ[¹Ú4@L”ÞïVÝrs*G—–IÝɱ¾ë…‰žC~Ó,ù­KºØÁ‘5‹WSc ¦éÝÇ”oµrèd´›èNÒô]7)Lnç·ÒŽ&¼ÅH¦5ĤõHßÀV™(Åù‡ñüÉ W­%ÂÙôó¡Â4?‡Ûº1µPrHùݘˆIaä[%5Æ;iz×®¢;9Öwݤ0=‡ü¦YòQß$Ý»7äwcÍáNᘠÜõ1}ùѤé»nR˜ÜÎïh}É6À…¬áq¡¶b*F1™Œ%²Xš*ùúɺÇ!ŠEh<+÷7…išü.¬Øôsx‰ü1Õ¦bJ¡\§”_×u¼»í:º“c}×M ÓsÈošîüfÄBÖüB¡æ˜jÓ +׆T]ˆ© Ý­fW;wÝIš¾ë&…Éíü6™>¦'DLa‰üɹ¨µ´;“þäbU-eÅ­Ã’ø›Â4M~G))Ä ÕV®1 SFy#&»t1Úut'Çú®›¦çß4K~C(Lúm³ jÿ,L©¿š± >G-Rñ1ŒvÝIš¾ë&…Éíü>XÚ£ êï–ÈoL‡êè+Uí¥Çdÿ²+ŒÖ¿ñÁÂ4Ýù-1'ka0äû³05¦b* ®^9TÔœ@LÃ’põTN²IÄ…”gö¿)L³ä·)º‘0”@±V¨MĤÔ÷©œÂè»ã/?º“c}×M ÓsÈo™–=‰ «:ÚÍÏæJJmê¯fb“o.ÄDr7‰W.-“:º“4}×M “ßù}¬¿¦,º§[ºÄkl`ÓÝg±1˧rvæ]B´Iµ-LÓßÖv«I<­i +ˆß§r%Ê]pµs×Ñë»nR˜žC~Ë,ùR4y ÓǪšßZS5³I׉ ÓKÐËKš“Ñn¢;IÓwݤ0ùߣþÂÉä_påºÛ˜X« $Óya}e–9¦È , ¥Àñ“ä·Ì’ßÙ~¡(’°nâmMƒI< ˜®9{¤øù¦WNÊ—Ýɱ¾ë&…é9ä·Ì’ßd"l&¦¸Tßi€˜"œã› 1½N蜤I'£ÝDo“fàºGaJ7ß…˜1E6ýíEĤ;1Å[Š´#­#&*Š— $ ãóÀ_¦4K~Û« `Wÿ·Þ˜Fså ]9vèáÝäXüò£;9ÖwÝ£0¥çßišü&¯FãØ ’Šü®MÄ,ïS¹£…ÆOš‹Ñ®£;IÓwݤ0Ýt~gE.Y· hŽ‹ˆ)˜Â9b$7o×ß&›™uÏ“loòÉÂ4-{‚ ¬Vêw(íø¦Ÿ¦b¢ï#…97מҥeRGwr¬ïºIazù¦Éo]øìÐP­.P›ˆ Ã{¯¦»ýºí:º“4}×M ÓMç7kšSÀbwå,IKñ1A-ä¼´|!& ú1f¤BEL³ä·VgE)g–\_â­MĤû¬K]À®Ü𘉿üèNŽõ]7)LÏ!¿Ó,ù-’‘1æ„MSc &"ysL6¡ò&iNF»‰î$Mßu“Âäw~c(ÅfX X‡òbR˜D¤àtKëwåbP”ÙÆ ÄO*X¦Yò;'Ý!Ù5Y ¥æ˜jÓ1i½¾4Ð1ÝæØÉh7Ñë»nR˜žC~§iÙ±Ž2±Öõ•”Æ4@LÞ7¿Yîaö¥eRGw’¦ïºIaò;¿QA«ÜS.(‹§r„)JÌ6†RXº’òúÉIE(ÃøáߦYò›õµ?ˆBýÍ*ÄÔ˜ˆÉ‰¾S.7½réd´›èNŽõ]7)LÏ!¿Ótçw’¬›0ŒÍþ¿5 S‚÷=&Öº!&óÕÎ]Go“fàºGaÊ~ç7¤’ I’H,­™1g@ô½Ê1™à &ë¡ÒŸ?,‰¿(Ly¾ó[ê.)NRmåjÓ1) y«¤â­Jj~·sWÑë»îQ˜òsÈïò1¡®ÞL@râ¸zWÎ.ÿZSg*ÙúQ?X˜fÉo.¢ÞF2UWRÓ@W^ÿº+Lj_#é½;í&º“c}×M ÓsÈï<­ùYо1 T –i€˜JøîüNùŽ˜Ì—wÝIš¾ë&…éFó[ÿEZ“¢¦úøl¬BL“ØTºWz ðüÉRtÏË(0ÖLùMaš%¿ k©I¿ÅjJJcLâÑÍü…ÊIóá®0ŒvÝɱ¾ë&…é9äwž–=±ãl]+¸nhLÄTðS7 –ùÒ2©£;IÓwݤ0ùßu#EÉd‘õ˜)²>iGâ«ßú“ ÙqžMýø¤º@ž$¿sí$ ¤\/~i€˜ÐOÄ$nÈï\¾üèNŽõ]7)LÏ!¿ó4ùBÔ÷ÀZj¹–Ö­M#Ž©Èµÿ×¥þîT®\Œv½Mšë…©øßQ!bÆÈ‹êH xÑKZž’¢?š’nylkýÉñMezàe"ýârH)Õ“xÓ1J.'bJ ïrìšbYGwr¬ïºGa*Ï!¿Ë,ù…õ› h(jËÚ4@L™9^ˆI8Ü%ÍÉh7Ѥé»nR˜üÎo›6Y’@ +"”pÊìc ÑçVz ^ˆ "$e:öÀŸ,LÓßv#YÑ[Âz }kN{—®<år7¾©\íÜut'Çú®›¦çßeºó;rJb*lP7X6¦bÂS’®¡–tÓù]èËî$Mßu“Âäw~ÛvŠ@7ŸºÃÍ«§r šÐfÝÍ­ö1ÅÂ!¢î­õü“§reZóûøæìî_ÆZ©6 SzĽfÂS¹„¼ëèNŽõ]7)LÏ!¿Ëtçwæ@¦ö_J%IÑšFˆ)Ë5%•åVZ·\íÜut'iú®›&¿ó;² $Ó‘BX#¿1Ùý[°‘ÕZ^pµ)Ú¥ )1Ù„ð"¦IòÛIÆd#Ï«+)­i€˜rä·º€æÛM»@I_~t'Çú®›¦çße–üÖ-‰¾ùºÐÖêit*'ð>•¼ñ*'£ÝDw’¦ïºIaò;¿uß™RàÑÕ5Äd²@É.´˜„ÉZa:~²˜è ñÄ‘Þo ÓôÀË‹5eÙÌÒj+טˆ©à7ÇTøv+wM±¬£;9Öwݤ0=‡ü.Ó²'Šú%K,Aªë­©¿š¥¨õãBL)¿Á2†KˤŽÞ$ÍÈu‹Âۯ Ø©\âºGXCLѪ Ùñøê$^ýÉ)™¾nŽú÷¦óëçXRø¦ ‹M+µ+É? Sm ¦ò’Ó=S‘=¦®vî:º“c}×- S !¿ÏÏ{œ4Ù&)1b9VSRS5K¦Ê}!¦”¢˜b¸í:º“4}×M “ßùÃÑJ” º¤ÅS9H&©[ìj‰)Æ­"¦P"ê~îu&øÉÂ4K~Û­}…­#ýgajL]yý8Þ“xÜèÊë ùåGwr¬ïºIaz ù}~Þã¤É¨i¬;Sbź©6 ÆoÄd³o’æd´›èNÒô]7)L~çwHB6‰Iì."&Ö¢T2ƒ}¢ãV¤ 1éO¶W&9n!?X˜¦Éoëô4kú¬ÈïÚ4Е·³Ù+ÇB ŸÇÔdùò£;9Öwݤ0=†ü>?ïqÒèKÏšaŠ_ê))i€˜0¤÷j–r¾+L—wÝIš¾ë&…ÉïübW¯D·cǾ†˜8}˜lVŠîSÐ]‰"Ö¢LÜgùMašíüf-´RJŒR« Ô¦b‚”Ò1å›û˜Z›¿üèNŽõ]7)L!¿ÏÏ{œ49‚éÚ¦J…˜Ó1ÑÔLæì&iNF»‰î$Mßu“Âäw~Û­cÝÛʱÆ/v~¿&Ò•£}¾¬ôàù““ ÛŒQ_´j~Ÿ_Ï8Ç¡ý91H5Tµ5 æ·æ7GŸüÖÍì—Ýɱ¾ë&…é1ä÷ùy“&#CkŠn¾à'ÌnMÄÄÞšß9ß´ Äx2ÚMô6i®{¦èw~Ù4¤£5į!&ý[mùŽ™Ùi‹ˆ ôÝLR‚~p,Lq–üæô‰ 6zL•i€˜0¿,9ð{åbŒ_~t'Çú®{¦øò;Î’ßtô.ZYÌõ%ÞÚ4@L‚gó[°séf+OF»‰î$Mßu“Âäv~kUÑÍ{å;y“ .b²Fä| ó‘9¦bÇKHÅ`&ú?ù7…izà%éöHX(H­ÇÔ˜Fˆ©ð;ÇóÝâwM±¬£;9Öwݤ0=‡üŽÓ²'d3@²¢ÙêT®1 S tuå{ëwåÆxi™ÔѤé»nR˜ÜÎïb•kLĤµècñ5hÉ˱“Ñn¢;9Öwݤ0=‡ü޳ä7sTHR0•\ Å5¦b¢ïS¹ø†˜Œ'£ÝDw’¦ïºIar;¿K,Åú¯Ïën+ˆ)@ɦ¯ &^¶p¤‡¯Ÿ¬¥)hu"ý!VûMašx©uV?±qõø¦Ú4@L‚oK¶=þMŽ]S,ëèNŽõ]7)LÏ!¿ã´ì ˆ©lè»>1iM#ÄTä­ùmJü7Isi™ÔѤé»nR˜ÜÎoý(èè…xm+§q±ù&`Zsk#Ÿœ^ÊZ8²}²0Í’ß6˜D«’óÏû˜­i€˜R,ï“_»­|“c'£ÝDwr¬ïºIazù§;¿ƒ~#YwîúÍTˆ©1 S¢rýŽº‰7\íÜuô6i®{&p;¿µ<  I%¶}Ù"bйhU1Õo·x*gÊUº›ûAqø“Q˜`–ü.líXr¡zAc ¦S_òÈ1 ñfñƒøåGwr¬ïºGa‚çß0M~ëv£Я¼â˜Ó1a ×j¦{®»Ât1Úut'iú®›&·óÛî æTR‚s’EÄ”µ¨wÝèþb1)À„(Á&?ÑÝúMaZÐü>˜x Tõʵ¦b*)¿û˜t¯{Ãc·÷ÏèNŽõ]7)LÏ!¿ašüŽI_xIúÔíi„˜ð{®œ>v—4£]Gw’¦ïºIar;¿‹ý¶(6ª$eRÐbJº‡+uÝÔ­"¦”b°Øæú“…i–üNEÿ¨‹ §ð•·¦‚…º¾5¿è¥1ïåØÉh7Ñë»nR˜žC~Ã$ù ²1ŠÉ&˜Õ,jÓ1éâ­`™ÃÝ%^/?º“4}×M “Ûù]l—331YDLvÓÐæÃÙÀ̰Ê1)ÀÔz&K0‰‡¦iòS°Ãx±K2UaªM£iÏùûäWøF)ÂÅh×Ñë»nR˜žC~ÃôÀˬ_uÔ(×íµi€˜˜ä[ÁRn&XD¸¦XÖѤé»nR˜ÜÎo;ãC?ZÁKXFL1ÛÕ´ž¿¸Ê1™â,‰]©65¨O¦Yò;ÛØ“ÌãTÝÇlM£iÏ¿s,ÃÝâw2ÚMt'Çú®›¦çß0I~ë–]‚ ý³.²ÕjÖ˜ˆ‰’¼W3~ì;IƒáËÞ&ÍÀu„7ß&o¬»Á•Éb É©`\k8~r<öŸïOª à´ì‰fFHÙx¯R¼¬MÄ”®—Çí‚rÓ.€—–IÝɱ¾ë… ŸC~ã$ùÒqòÃA¿’XÃìÚ4R|+XÒ«„xI_~t'iú®›&_ó[û‚Iž¦üÊ­’1nZ%‚©P¯Þ•‹„Q~°vùŽo:¿ž‰#›$E¡†º05¦Ñ$æ+Çt¿îrìÒ2©£;9Öwݤ0=‡üÆYò;èŽ#+¾)1—Zö´6 õ˜ðÝÇdm´7Is2ÚMt'iú®›&_ó[d=ÑîÌ-h½ˆI˜ ¤h̯v~ÛOÖ5"žÒ5øMaš—=ÉÀZ.K¨.ñ6¦¡Jj¾“qÕw9öÖ2©¢;9Öwݤ0=‡üÆÙÎo8^t¥×Ä®?rLµi€˜t»&X°~Ów0ûlçn¢;IÓwݤ0ùšß6\_#‰úßhq¯Ãd Pl_±¬ÇtiçP†Õo Ó´ìI²‹Ì¬•êái”c’®¹r¶½¿á1ñÒ2©£;9Öwݤ0=‡üÆiÙ“lMøºs7±ŒŸ…©1 S`y÷˜Ø^ý&i.-“:º“4}×M “ßùs–€A´–jX<•ÓRÿhݹÕ¹rEQeÔJÂÉoœÖü¶ P"­%]ИF9–áBåbÛû›»„¼ëèNŽõ]7)LÏ!¿q¶óÛV‰`z"úÝTã›ÓhÿŸË»+7d¼!¿élçn¢·I3pÝ£0‘ßùm;OÅ,vžóR»€‚2ÅÎc*]XгŸ\P‹adýÍÂGOåhzàe0õrD-—¹V¨M£Ká}*W¢Ü4ñÒ5ŲŽîäXßuÂDÏ!¿i¾ó[±HæXts])X6¦Ñj&áÝǃܦw;wÝIš¾ë&…Éïü¦TH÷T %„EÄDdíúòÚ0ûÉ 0¥Àñ“—xizà¥VY«cZ-«Ù…­iÄ1eyëÊçr§ùM×Ë:º“c}×M ÓsÈošx™À. èv©ž’R›Fûÿœ¾µrî“æšbYGw’¦ïºIaò;¿1k­ ppà‹ˆÉz#m¯Ö&HK/ŸLǼKBBþhašîüNº±%LåT…ÿ1‰·2É•›äòMŽ]íÜut'Çú®›¦çß4K~Ç’³nØ^ýJ(®1 S ù{‚E¦މNF»‰î$Mßu“Âäw~£¢•L,¬©>VEªŠb&¶û¸4”_?™ìŒP>Ç7}¬0- ¼d tg[ª1ôi„Ê)~ß.H·¨ü{ŠåÏèNŽõ]7)LÏ!¿i–üÖ%(ÙèS;¬’¦1V3ˆ×ïhã›óMÒœŒvÝIš¾ë&…ÉïüŽ ‹Èév,ÀªºÚ™^]^„®v~‘«Ÿ•Dý´è“wåh–üV4BÆÉ³¾ú-búiåæ7Ç”øîv•/?º“c}×M ÓsÈoš%¿£ý˜~_f©Sm!&߈ ïú˜8|ùÑÛ¤¸îQ˜Øíü6‚‡µ>a­«K[9ý‹Áή9[È×,Ÿœ…e´ANŸ$¿yºó[7¦1'*¦õ³05¦bÂò¾]`Wnnrìj箣;9ÖwÝ£0ñsÈož%¿Ñî/f´HêaµiÄ1üž’ZÂMŸŒvÝIš¾ë&…É×üY7s6ä;›Ðí"b}E­—I ò*Dzn4E„ׄ¦Iò;p»P©æ1Ó(ÇbúžöÌw#¿üèNŽõ]7)LÏ!¿y–üLÖ˜m&uø™4itb|˜Ýº½Iúò£;IÓwݤ0ùšßšáPCšò ®ª ĤoH¶¡•㙕b váù`r#çOrL&™%¿õ»cDѤÐÿ­¶rµixòKïû˜\î®=ÉÉh7Ñë»nR˜žC~Ë,ù)–ƒk• 15¦ÇôšÈõBLt§Ç”NF»‰Þ&ÍÀu”ÜÎo›£+Z êîc|•ögÒdE—nã¾u)_¨jøúÉéÖW¼ãù,¿(Liºó[raÅ»3Õßµi”c‘ßšß&ër“cW;wÝɱ¾ë…)=‡üN³ä·½ëšüÅfjTSRÓh5 ï{LdC:n’¾üèNÒô]7)Lnç·IèÚµª†´zW.“‚%Ý’-0²r_?¢þL{…Ó¸µó7…i–üÎÅîÉïªÂÔ˜†'¿åÝǤŸîM»@:í&º“c}×M ÓsÈï4K~†µ’S[!¦Ú4<•ƒøFLî’æd´›èNÒô]7)LnçwŽA—`Éh7q©]À@Of*©ÈÊ_|ýäœ &2yÝO¦iÍo´64—Wk~צYð}îPù%ä]Gwr¬ïºIazùfÉï`\G†ëÂÔ˜FS’ëÄ„ä5ÞKš“Ñn¢;IÓwݤ0ùßZQJkF «“I)"[ç+ìZEL&óHv½B ú'ÛÒ,ù]äÑíeªSck~Oâ…;iÝt2ÚMt'Çú®›¦çßi–ü¦¶cP,X_I©MÃS9¹V3²•ç&iNF»‰î$Mßu“Âäw~#ÇP G)¸ØÇ”ñÐ / ™Bó×bBÓcÄ”à³Bqizà¥nM™ë0R‹˜~š†š_r¡rS¼Ë±òåGwr¬ïºIazù¦5¿L^#}ù+ÄÔ˜ûÿLòîü&˜/!ï:z›4×= Sö;¿m´šºOÄÈ‹wåìÚ¯Âz)qex &ÝT0Jˆºbµ_¦Ù`™§5¿ ظÚR©¤¶¦b²ëïS¹»^¹| y×Ñë»nR˜žC~çYòÁÎBÈRÊ5¦bJ¯™_„|Ç1å“Ñn¢;IÓwݤ0ùß| Ša» ’d1E£ú“ýH¹,tg¾ú˜@$ÛãŸíüγä·DB›í­ï}¨:¿Óèä7½{åX7¼7· òÉh7Ñë»nR˜žC~çé—ZBJI)(˜­,ÓˆcŠriånÔïÓ5ŲŽî$Mßu“Âäw~mÍ¥`б&{¢¸ °nƒ ïcÂ¥+)ÇOŽE ¸”¢ý“ßy–ü&´†jÝàsuW®1ÓÕ.`§r|[˜NF»‰îäXßu“Âôò;OËž@4MÑLEb…˜Óˆc’xíÿµ0Ý‘ßùÒ2©£;IÓwݤ0ùßD¡·û¤äñ¡ýOÄ”lGa­5PÿøEÄDQ¿‹lRŒøQÄ4­ù­_ C°¤Ñü®MÃ^9z« èx£ù/!ï:º“c}×M ÓsÈï¦øêñ’æb´ëèNÒô]7)L~ç·˜<@ŠºÄ';J\CLQ ë[’õmÁùË—º@κô3ŽC‚ê7…i–üŽUaªM#Ä„ü>•€»¤¹´LêèNÒô]7)L~ç71I&«8Ôý1ÙURûó‹b­GS±­ îJ²(ìúdaš%¿“þ"dšž15“xkÓè®\áïiÏù®W®œŒvÝɱ¾ë&…é9äw™&¿í²)ĈµìIcqLù}óÛÄ“nÈïr1Úut'iú®›&¿ó› êV CÐ7 —®¤è'ÉŠÂC–¼Òù☠-g&ì›ÆìÖo Ó´ìI.žĜC-­Û˜†“x¿ÕB‰w¨üÒ2©£;9Öwݤ0=‡ü.Ӛߌ@±„D±™ùU›F}Lù»ó;Ò$„KÈ»ŽÞ$ÍÈu‹ÂíW÷êcBSj˦zÊb“(PRă)ê–xü>~rÑš$ˆltÓç ÓùõLäX°=¸î•ØÔ*³6 ïc†÷]¹o^@ˆ_~t'Çú®[&!¿ÏÏ{"i„I3Ì`á˜?ñãJJe &–pÝcÒí„ø²'àËî$Mßu“ÂtÓù­µ%¤bwe¬ŠT!&C#ÖJH‚2ÞÕ}Lµ*A²!|aXÕ~S˜¦;¿Å$µÊÑÊ^õ15¦bÊß –An¤u \íÜut'Çú®›¦Çßçç=Nšc4’ S`\]hMÄ$.Ž K‰~ó„“Ñn¢;IÓwݤ0Ýt~Û°i@E.v“f 1)Ô‰¬û8uA^Ëß6U.*ì‚øÉ­ÜùõÌä˜n”Ȧ–F †.¨LcË·æw›»røËîäXßu“Âôòûü¼'’ÆÎâuŸL¸¶ÚÊ5¦bB)oÄ”ãÍÌ/'£ÝDw’¦ïºIaºéü¶ñ (ö&¥µK¼&³@ •‹¬À-<rQÀ”LAó“ßç×3αd#ôŸY ‡1Õ¦QQx#¦—Ƽ—c£]Gwr¬ïºIaz ù}~Þã¤É$Ú¹QQ[ojLĤáš’‚¦Ã“4—–IÝIš¾ë&…ÉïüFÓZ°žõP$/rL ZŽgå„‘ÖdO^?ÙÀš·„cùËߦIò;›0²ÉSæZ¾¹1;¿¯÷ÀþJÿäBùò£;9Öwݤ0=†ü>?ïqÒ¤TŠ!¢”ŸSk &HáZÍ<•›¤‰áËÞ&ÍÀuÂýÎï¤u:"  6_Š³ë©˜$P¶ÅªæwŽÄu_Rð“[¹8Ûù͉lw* 8Ô§rµi€˜t‡|ÝÇ´y^~»Ä³»‰îäXßuŸC~ÇYòE7]º ³Õ½¾’R›ˆIßÀ«Ç™ñ†cŠðåGw’¦ïºIaºéü¶ÁĉM²%®ÈvÃk“õ0…dV;¿¥èn$Ù•˜‰Q›¿)LÓšßZžÁšd¡ÚÊ5¦b²›>Çóæ7ÄKÈ»ŽîäXßu“Âôò;. ¼<.²|íÞ¼üiê¯f\Ú\ˆ‰LèÚOšï)–?£;IÓwݤ0ùß`ü2ÅoáÐcnÖJëK¨»×5iÝó'£Û5ùðÉv8ÛùmŒcHYAoÉ•‚ec &2Õ½1ég{Ó.Ïvî&º“c}×M ÓsÈï8/{’õÝ ŠI^›¯²'•i„˜8]êHùf¡nǾüèNÒô]7)Lnç·Í`ÐmÁqx¿È1iE)ж¬?ÓT‚Ö“ýd:X9 *óÁÂ4I~ë+Ÿ¢dNÇX©Ÿ9Ö˜ˆI·oo=&»xu“céËîäXßu“Âôò;N¼ %@ޱKÝüV›ˆÉ.C\ˆ ‘ïÓ5ŲŽî$Mßu“Âäw~‡" ,éïM‹}L6‡WÿZ}S"ÐÚø¦×OV¨f7FJ¢^â=¿žqŽ¥Lh—ŠË±Ë¬¶rµiÄ1!~#&¹¹Ä«ûËîäXßu“Âôò;Î’ß…… ”XÃìÆÔ_ÍØÆR_ˆÉ®kûI'£ÝDo“fàºGa¿ó;]ô@É‹Bq&ƒ ´G»•²Ê1écF˜ÝËeùä©Lk~$]¨P¸H}ÀR›ˆIrúÖc¢»S9¸„¼ëèNŽõ]÷(Lðò&ÉoÝUëxÁí0ÂÚ4@L.Ä Ý% |ùѤé»nR˜üÎï ¡ uÇXM]"¿1 !S¤¯\´Ãó'›$“©àXeî7…i–üÖ%‹l\©hRT—xÓ1e(ßsåb¾¹ö'£ÝDwr¬ïºIazù ³äw)‚ú¥¤êcjLÄ¡\wåtÃwIs2ÚMt'iú®›&·ó;±ë´‰%rZT@ëA:;­¶-ê1ÙO&¦…6T情i–ü&Ž£nôµ’Tˆ©1Nå¢\¨œC¤»Åïd´›èNŽõ]7)LÏ!¿azà¥Iÿèb!™BE~7¦b²içj…ù¦Ç®)–ut'iú®›&·ó;a4%5LÑæ/v~#ÚÊb:¯‘'vc?“&a°ÁQ E÷ZôAËóëçXÄDDž末ñMi€˜ÓÅ1Q¡»8Û¹›èNŽõ]7)LÏ!¿aZö¤$‘ÁÈÖZó»6ó7bÒïø&i.-“:º“4}×M “Ûù¬U qÑ}•ä²8‰JFL:g\ÛÊ?Y¨° /úã?Y˜¦eOä¸QÌdÂ"õV®2NåÒ1ƒvs*—–IÝɱ¾ë&…é9ä7L¼Ô@ß|ѽW}”Û˜ˆIè‹c2ø›+)xM±¬£·I3pÝ£0¡Ûù-™Éä’]u‹šß LA0˜¬NIÓ=9ælBË'Éoœ%¿‹µ/Ù«–Ú4Rx«¤j)¹9`ÁøåGwr¬ïºGaÂçß8Ûù lÒX!ÅÀX#¦Ú4@LQÞ÷˜@_È›­žíÜMt'iú®›&·ó[‹¨ñϬOâI¥1QŠú’˜Ä9ËÊ}|ýdÝ‚ÖpI‡ ¿)LÓä·®SÅN)Ï3µ?"¦Ú4ÒcÊoTN¦9y“c£]Gwr¬ïºIazùÓšßL1$‘×TøSR*Ó1Å(×þ$ÉÍþ/!ï:º“4}×M “Ûù­EcAÆaIöDË:h5KÌ©XóÖ"ÇdåHLˆ!Cöü¦0MËžÙ‹~•|scM{¦ôžöÌ ý¡ª€—–IÝɱ¾ë&…é9ä7N“ßÄñÐZÔu½^›ú«™5{_ßúNÜÂì‹Ñ®£;IÓwݤ0¹ß’ ™Â}²žP^Ôc@­ÃºMú¬"¦r4Œƒ~b¦Ö÷ÁÂ4Ûùmö öÚ0åêä·18¦˜ß³ Ü5XâÙÎÝDwr¬ïºIazù³ä7¦dÓË@Š„zDxmê¯f$ß“îäî ÓÉh7Ѥé»nR˜ÜÎo±iPìΠ&ú‰ÿ˜b‰Ùæ„CÄ8žò]sL˜­‰ŠãgÕp–ü¦ã äḆn¨M£)))\9F ù1ŒvÝɱ¾ë&…é9ä7N¼ÐõX¿ä„UaªMÄÄ%\ – ‹öÍjF×Ë:z›4×= ¹ß¢¿² µ1éŽn|c­BL¡¤hêÓ¤AÖ¶rö“c;–S´EãóÀ_&šÕüÖß#é¶–J¨ÕZÓˆc’ïS9¾ª t y7Ñë»îQ˜è9ä7Ív~':†¾BÒ S5Œ°1 Š\, ¾hj/iàËî$Mßu“Âäv~KÉZTÀ”7À,Ε³ý éFHBàUÄTôS*E×þ’mvà ÓôÀKÐ_Ç=õ­¯OåjÓH]äš+GçT/Ç®)–ut'Çú®›¦çß4­ùl*’.ð¨{€j5«MÄtJÚïõ[¾+L—wÝIš¾ë&…Éïü9fļ8‰¢˜˜b>™V†Òáë'ë>0뛦ŸÚX;ó7…iZöDÿ ›$Ý ÖÒºiÔùñz(ÉÍPU KˤŽîäXßu“Âôò›fÉoS$cÓ›Ôïüçþ¿5õW3´ÓÖs5³WãfÿOòåGw’¦ïºIaò;¿êV,%¤%.ª € êf)1*hZÕüÖŸ¬?3‚Çqwæo Ólçw±¿¥PT «ÂÔ˜FO{¶ì79v¶s7Ñë»nR˜žC~Ótç·‚+&kħPåÖ¦þj†é»óÛÆ™Þ4XÒÕÎ]Gw’¦ïºIaò;¿Á~逶½¥• L¯S9Б&ÆÍ|ýdÝþ BDã[z¿)LÓ߬@$IR)X4¦Ñ©\É×\9¼›]HW;wÝɱ¾ë&…é9ä7Mw~k!Ó‡¡FLi€˜Þ –&ŽvS˜øj箣·I3pÝ£0±Ûùt[L¥5†´t÷ÕÇ„ÂÙBdV𴊘 (v%Ý rÀOrL<-{’13!¶×T¸?ò˜µiÔùâ1Ñ«uÀ˱KˤŽîäXßuÂÄÏ!¿yz३B**·{²UIc &&¾~ǨOܬf|M±¬£;IÓwݤ0¹ß)jeÖb 9K*Ë}LØ!3¤%Í”×]9(Ðtuy¢µó7…i’üÎ&xWòÑïY‹6¦JjŽüFLä.ÇðËîäXßu“Âôò›§Éo(¦ ô-Hµ´nm &“¼Ý*XòÅh×Ѥé»nR˜ÜÎït\“³ÃdWד>bˆRb’Õ>&ýÉ,Qw%ú3}ò®Ï’ßÉît£þQk=¦Æ4êüŽïI¼„ñn¨*ŸŒvÝɱ¾ë&…é9ä7Ï’ßÖ¢¬¯}1aíz+W›ˆ ðÝÇñfË—ÝIš¾ë&…É×ü&뉱Q¸&M½ˆ˜r"¶ë[º «ãVˆ‰´š¥Â —L×é“…i–ü&1&^A$çR‘ßi4íYÒ1ÅÛK>í&º“c}×M ÓsÈožîü¶fW±¶j] ¦Æ4@L¾p¾ñâ«»Žî$Mßu“Âäv~+\²±æ!ê?ãÚ•ã˜²Ý &‰µ¬ÇdR ‰LVÆÿ¦0Mk~Û6<Åp?¿Ö4@LÄüÖ•?§òx9v y×Ñë»nR˜žC~ó,ùm—ª…*IŠÖ4@LAò¥Ç#ÃÍþ_—½Mšë…IÜÎoë–l².Á‹šß ut[Q´ÀpÀ¸Ê1‘îãlD¶—ì“…I¦eOÐøxÊÖÓU7X֦ѴçKZÇÚSâÝPU¹´LêèNŽõ]÷(Lòò[fÉo]•s ;ÒŽX“©¿šn¸®®\{5î ÓÉh7Ѥé»nR˜ÜÎïdstƒõ)gÎq•c²éâL¦ŽKI~qL ÅÌÔ ìPï“Bq2Ûù­¿ÒŠBÀêÚSkM{.|åê‚u³•“³»‰îäXßu“Âôò[fÉïtŸ”ôò’vÿCajLýÕì¸Î~þއZõ÷û‘4'£ÝDw’¦ïºIaºéüæTR!ÌÉn_­ê1™–b.‚nWçÊM9~ö®œÌ¼ä ÛЗŸ…©1 4¿²¼s ™ÂÍ‹¼§XVÑë»nR˜žC~Ë4ù]bNº¨KЗ¨"¿kÓ1áÅ1ý¦ù¦0]ŒvÝIš¾ë&…Éíü6 tè}'Ôú´Œ˜‚Ý·ÛŽ)fZV°L`¥¡ä±fÊo Ó´æ·iÖDÝ›©ô˜ZÓ@ó‹ù­Ç„t‡˜.!ï:º“c}×M ÓsÈo™&¿I‰î:J µSc!&ÆëÄÄŽ^ÃMaºí:º“4}×M “Ûù-…´’&ˆ1Ç‚«wåи“¡´A'‹ˆI2!'aTt1îÎüMaš&¿¥XA‘j }k &ûT.Äd]7…éb´ëèNŽõ]7)LÏ!¿eºó[>C"¢KFµ•kLÄ”^ÝÞá˜!DXü”®vî:z›4×= SºéüZRXVïÊA,Ù¤öDÑÖªº€þdkz cÍ”_¦4K~c 6.é»_ojL£I</TŽîZRÒÉh7Ñë»îQ˜ÒsÈï4K~¡ tÑ…¶îÊmLĤûô 1Iá׌y'iNF»‰î$Mßu“Âäk~ëÖSë4ç «0.žÊƲs5Y™Vz ðõ“Ť˜2Ù4ÞOj~§IòÛ†í¥uºîünM‹RÊ[ó«„»“ßôb´ÛèNŽõ]7)LÏ!¿Ó,ùìÒÙ+”k¡¸Æ4â˜2\zLbâÌ7…éd´›èNÒô]7)L¾æ·é`—tŽ k‹SäÌ%Û _C[ã˜0»ûË&bùYÄ4K~ë¶RPt©R _µ 4¦æszk~Ù ˜›Ât2ÚMt'Çú®›¦çßi–üÖ/®²§”YªñMiÄ1•té1‹.=7äw:í&º“4}×M “¯ùM‚À”#›îºˆ˜0Ù jDÝËÁŠÊ¾~r,)躟C‹9ý¦0Íj~[c•ÂiÝžTòÍi€˜HÞ¨ðæJJ:…¼›èNŽõ]7)LÏ!¿Ó$ùŠ­íF#rs©18¦œÃ¹šéé†üNùËî$Mßu“Ât§ù­Yu;e—s9¦ú'sIG…Y™–yj~‡$Öˆcvë7…i’üΤ Ñ:Xô©,ÓHW>Ð¥.,wSRRùò£;9Öwݤ0=‡üN“äwÊ Aó?—³§öÇuÊ4@LÌïÎo»Ã{S˜røò£·I3pÝ£0å›Îï`’K+Ê%ba}°X÷ø’ìÉñ“#fJh£í`(¸ò‹Â”g5¿1Y÷ÛS‘ß­i4‰G!Ó…˜LWÝ/L9~ùÑë»îQ˜òsÈòlç·èÚbݱ…sª¿Æ4@Lº<ñ…˜ìäó¦0íÜMt'Çú®›¦çßy–ü6E2Ý#†Ä•ìIc &…Â×ïø†üÎ'£ÝDw’¦ïºIaò;¿uï)ÅR,yQÁÒ&¤Q…Me¬Ž[!&£KR Â&ÆøÁÂ4M~SÎ0ØïS“ßµi€˜ÒIçÍï|1Úut'Çú®›¦çßyz८ª`5Å6? Sc ¦ÈpqLQB¹ÛÊ]S,ëèNÒô]7)Lnçw&mk“¾íÂÜê©\´³ø˜mråÒ0ûɱè&§4å³OžÊåÙÎo°QçúÕ•RBÕÇÔ˜ˆÉ®Ž¼9¦w…élçn¢;9Öwݤ0=‡üÎÓß…¢5ã—š˜lLÄÎk(¶ŸàpèyIsµs×Ѥé»nR˜|ÍoÓF›ŸÄ)Œg•üDLvûÖä˜@a£‰n²ÁGLbÈeP|ùÉÎï<ÝùÍ6A1´þ»:`iL£Ù…Àt!&›S˜®vî:º“c}×M ÓsÈï<ÛùM%(AŠTé15¦þjKŠW»@ác¥o“¦œíÜMô6i®{¦âw~çRìžCBÑ’ºx*—lÄ{ÎlŠßñ¸’2]˜ŽŸ¬E E¡…–µOª ”ÙÎo ¹°µ?$€ª05¦b"L—º(ª¼i(g;wÝɱ¾ë…©<‡ü.³ä7ÙÅ ÅÅ%V[¹ÆÔ_Íb r]I)Q ‰˜ÊÉh7Ѥé»nR˜|Íïl {” 𪓠OÛQLîm1éŽ:¢© ØÝçO¦iòÛnag! šcªMÄ„á­+oÓ÷nÚÊÅh×Ñë»nR˜žC~—iÍo’A_ý©Öü®MÄ”1^0;š‘Ï1•KÈ»Žî$Mßu“Âäk~ç„Q¬)4rÀEK}ÐT XKT‰«ˆI¤‚-}ì-þ`aš&¿cÔ„Ô¥—|àS¹Ê4@Lú¹¼;¿C¹EL£]Gwr¬ïºIazù]fÉoäÂ!P´ëÕ\ùÆ4@L&ñ&&Ó]S‘/?º“4}×M “¯ùm“€02š”gXà¯ÍMXtk¡õÅxÿh…‰SJ!†b÷ƒR‚nåfÉo›»u(ýsàJö¤1 S„7]ËkÆœW˜NF»‰îäXßu“Âôò»Ì’ßAöŠè’*=¦Æ4@L’åº`©ßo¾éc*'£ÝDw’¦ïºIaò5¿SH)C²¥ÂÒ\9ëÐɦ´¯k¸bмD~?Ù†FØ2…ƒO¦Yò0ÓÑÊŽToåÓ1 —æw,ñ1•/?º“c}×M ÓsÈï2K~+vM“Ñ8õ]¹Æ4@Lú ^#ÂI1±˜0œŒv½Iš‘ë… Û¯îÕùs›mMVi 1Ùü%`&»'Ö Óñ“GN‚ÖåúÁ>¦óë™È±õ7ކIêů6 tå3ñuò{Üp †³»‰îäXßu‹Â„á1ä÷ùyO$ õ½Øð©ÉïÆ4@Lg_‰ýެ_¯¯Ç„ášbYGw’¦ïºIaºÓü†`×ýðXGò'bƒK% °c¢EÄD’>œuO’òððo Ó,ùmͱX t¤JZ·1 &ñ$)×KThn ÓÉh7Ñë»nR˜C~ŸŸ÷8irÔX²¾™ê—i€˜è%±uÈž¸-LôåGw’¦ïºIaò;¿¡˜`·d4EÉEÄ” ™eÊö­ &ÝÇ ZìEû æ÷ùõŒs,e¤¢›{A(õ””Æ4@L’Ò{Äâoå0œŒvÝɱ¾ë&…é1ä÷ùy“&3ꢬHˆJuW®1 2_“QBþ©†“Ñn¢;IÓwݤ0¹ßú÷›ô¶î’þÖ‹Ã* Ø8_Y*LÇO&ÑI!Óú(bšx™uÍ2©ü¹øµ¦bRôùFL¦uuS˜®)–ut'Çú®›¦Çßçç=Nšl:ŠD„K-âÕšˆIaÚu]@ßÇ|Ç1]íÜut'iú®›&_ó;³"=ÑßÚFÃ-žÊ%›:\PKS¤—4Ábëa6¥G›ã4ƒð›Â4+{bí 1§X£òÚ4@LÄtMI‰„·Ó©eÒDwr¬ïºIaz ù}~ÞISHßzÐå‚^»÷?$Mc ¦XÞ’ò1¾Ù)Lñd´›èmÒ \÷(LÑíü¶QÖv}B7r±¬Ì88&Û·È ·¬!&ýÉÁä°Œò›ØDþ¢0ÅÙÎoSwKZ¥mÂ{ÕùݘˆIAÒÕÇmر_˜âÙÎÝDwr¬ïºGaŠÏ!¿ã,ùÊ¡ “.?Õ•”Æ4@L6ªèL-%7ã›0žŒvÝIš¾ë&…É×üf»ql 4èwQöD‘¡Ø¼Ž¤wƲˆ˜ø(G6‹ ޵3S˜&Éï=­ !IuŽ5¦búÿs÷¦ÉÑ츒èzôã–‘boÿ[z@fDêˆ3û³4£E §n7 „”‰p: ÂÆ©sW#þ´£7rlìz0=GüŽ«â·’(Ûúj+UŒ©0MS`ºOåT#µë˜0ÒO;z#iÆ®‡S§ç·‘CÅh¿ô¦ÆÄÀöšDðõªí0&Ä”ýŽ|ôîB_¦õÊoãŒ~¹«~L…i˜bÒ[.°…Û#ÂmïüÓŽÞȱ±ë!Àôñ;®·=±MG èãŠÊïÊ4aL! ~’&hû“¥ÖO;z#iÆ®‡S»ç·q;¿àï7ÖcÜdLä˜m#9ñÖVîýäè×52ú¹oÓªø-ú¦ÞY+ü¦Ê4aLðž+g9öÂ[9v)ÚUôFŽ]¦çˆßqUüfï&bï=†\ޝLãÕL!àëâî+i’t„Éx)ÚUôFÒŒ]¦vÏïh˯!*&•²9Œ½Í›Ï0ð‹[qk+÷z2åàíDƒ`üb?¦ëë™ç˜$fóÇQ.Nå*Ó„1y§±{ñ Úý˜ìÏþiGo䨨õ`zŽøWÅoðéÛ‘‚1. ,+Óx5{õ¿}Ó«kug‚Â¥hWÑ뤙¸žLЬüN}šnv½v«»€Â¤T…3ñ’½^`ŸX¢ùõá&X¿5¥àg…1•/JӤ痟šÝrtjåàR´«è»žLðñ–Ûž@ Yl­°ýuÙ©4W3ac57c²mDgÿw/“2z#iÆ®‡S³ò;(Ùžííµ=Ýîˆpß»2’DÛÁÆ-`z?Ù;'ô¦Œß,€ÕÊoö)ƒ)¢L/SeštI5Z~÷•·Åê=ü²‘cW9w½‘cc×C€é9â7,Šßbß®½ôÉ^ú÷ÜÿîÿKÓx5K9¿îu½“Ñ›ÍúiGo$ÍØõ`jV~'ƒR#MjísÙl{H‚—¹û†¸«1yÇo¿ ÃÁæ¾ L«â7“fo¬Iâó¤þSiš1¦øÑ˜r|w°lÓ¥hWÑ96v=˜ž#~ÃòÀKNÁÚî½­S™&så½à͘üg;ÀtO±,£7’fìz05+¿íð ¨Ïݰ½ØÞVÎÈ"¿†ð x3Ò¶'¯'Ûƒm)Y¾º•[¿S"¿~m0 Rˆß•i:»Pï’/©ïmåä§½‘cc×C€é9â7¬Šß¾SJ¶Är,Nå*Óx5㈯=Ë‹11I{´Žm0~ÚÑI3v=˜š•ß^ c<½)"¤Í­œíãìo B‘½Ižý0¯3&2å`ï̇“ÿ 0-÷ü~•?¨7Z¢Seš0&CÛû=HFnz[¹»‘w½‘cc×C€é9â7¬ŠßŒõ¿(•×JÓ¬»`"¸S ½ ?íèuÒL\Ï&lV~W!Vζ™ãÍ+)š!¨wÕuûuWn‡1Ù“JÊ‘¾:Wîúzæ9f;Ë,¶µ%Ъµneš0¦¤Ÿ~L¯á”m`ÂKÑ®¢7rlìz0ásÄo\¿QÔ•Œ„Ê+)•iRc‚ùµíx1&cÆÆ„—¢]Eo$ÍØõ`jV~sòò¥äcÑ–Æô^Rš¼e·ªOžÝÒ˜^OVÛó€áxüf®Šß–È3ê{>óŸiÏ…i˜RÀßÖ:!tŠxñR´«è»LÏ¿qµò›mË"Û†µhW™&«™O¤¼“7ìÓUÎ]Eo$ÍØõ`jV~³ß%É$ì5Ii«ƒ¥Wëpö \Q¢bØ<•{÷—õÙMüÍa×׳cÑ;׍¹^™f9ä®c¢¨Ù…ˆüÓŽÞȱ±ë!ÀôñWÅï×eO#ýQR.4¦Ê4ëùÒçTNrê1¦KÑ®¢7’fìz05+¿™^SxsVÙž’“mâÔ>ížÊ½æ’û|q…æ½3ÿ˜–ÅoKŒìº:ÁÿßT˜&Œ‰(Äë=@JÐÛÊÝŠv½‘cc×C€é9â7®Šß>¶Õ¿Ä\lå*Ó¤ò;fº©÷cî\°ÄKÑ®¢7’fìz05+¿Ùö²â#w†é¾†(äàw³ìmå^O6Z¢mL|yø&0-W~«ó&+YSiš0&Lx·o†$¯¶'-`ºË¹Ëè»LÏ¿qyà%€¿“bL•iRù öÜ×Käâå%L6€‰î)–eô:i&®g5+¿Y2xûW’­—^CŸ!Æ×_›/_O6’æM0ƒ·Øÿ"0Ѳøm»#PfŸ­PŠß¥i˜ åOw¿Ð&ºí2z#ÇÆ®g=Gü¦eñ$¼î.rÙ(®4“ÆÞ„Ïñ)îÜ•£[Ñ.£7’fìz05+¿9焚!î2&UFMˆáÕjnsJŠ?9«}ü>Bë«wåhUüÖ|SúÜRôü®LÆäTübL1díˆß„?íè»LÏ¿iyà%B âh|‚Ùß:¦Ò4FàsåÞÄ€›ßtO±,£7’fìz0µ+¿]¼6¤VJsÞRœÊy;Åd›@È9‡ž)×]9%‹Òë¿ß¦ÕÊot¦,¯‰’©2M“%ÙgD˜74§=#]åÜUôFŽ]¦çˆß´*~GgW¯öÒË“Ò4&#ßÝÀ{áw€éR´«è¤»LÍÊo?ÖfÐdÛÏÒ”·WRÀ;zb4PÖ ºõ¾+ç³É_µ>É÷›À´*~Ã[lãï9:ÿ+Wš&ŒÉåéë= ôn¢×ʱKÑ®¢7rlìz0=Gü¦eñÄUÖD–Å¥ø]šfmO½®äbL¡sWŽnE»ŒÞHš±ë!ÀÔ®üÖ 1x3`ChÜ<•‹öþªm]ƒÊün¡1Ùs®eN¾z%…VÅo&õ^äI¥ÜÊ•¦Éɯ‘šOÛH¹#~Ó¥hWÑ96v=˜ž#~ÓòÀK[ÚcŠ1±T–¥i2¾9 è͘ŒwÊøžbYF¯“fâz0q»òÛ›”ƒ—'È»­u£ïá^¨&~ím1Ù“½Ò¼ëwLß¼’«â·¤·òŒ>W¢ØÊ•¦‰\í»ÞW ”FŽ]Šv½‘cc×3€‰Ÿ#~órÛ/Y‘4â*ÓäJŠ Å›1Sè0&¾{™”ÑI3v=˜:•ßÙvSÞw;3Áæˆðè¸l[‘)lìß•ßöyE¶Nˆ8ÿá¦å—Ù‡•û”[áBcªL³Z9N÷ø&è_Iá{Še½‘cc×C€é9â7/·=ÉÎCÞ=˶'¥ir‰×/RÜŒ‰sêˆß|÷2)£7’fìz0µ+¿ÅV_ò[)Fz`óT.ú¤J±ŸÖ,[[¹×“A%Mѯë}˜–{~#y§a–Ê«LÆ$oÆ„¶ñ’0ݼËè»LÏ¿y¹òû5²Ý¾{ý‹—•iœ4ÉYÂ͘X{—xù.ç.£7’fìz0µ+¿,ýɂ7íßì.`Œ “†>È`®_Œ‰!z[ÞD¾y*Ç«â÷«ÓŸ0ã•b+W™&Œ‰s¸ , vÊøR´«è»LÏ¿yyà%G£Ä~¾l;¥Bc*M³:¦„ww{Ó=ŲŒÞHš±ë!ÀÔ®ü¶_ùÕáÞ~iÈ›wåâëTÜéÉ»Œ‰ ÉsôQ¼¾Ë˜VÅoñ¹)ùœ=.:XV¦YIJÈŸK¼ñ=š¢L—¢]Eo䨨õ`zŽøÍË•ß1‰íˆÊ)©•iœ4|úîŘ$KGcJw9w½Nš‰ëÀ”Ú•ßœB¶õ=i$‚]Æd`†|CagöÓ›1%@µ§Û£ã¼Öà€)-‹ßö®g ™1þÕ1kÓ„1Ñ{Á«í‰ÑÂcJ·¢]Fo䨨õ `JϿӪøíSÛ¢ªz™r9Œ°4“F_}¾/ƤثcJ—¢]Eo$ÍØõ`jW~³1ôæÛ1À¼+RÙZ×õô ¿q·Ë˜PÑ»Äe?ýþæV.­Šß>¸EØi|¢¿µrµi˜>ïA[~;Àt)ÚUôFŽ]¦çˆßiUüÎ1ˆ¾®/,*Ólàeø´=ÅÐ+—.E»ŠÞHš±ë!ÀÔ¬üæ¤"F^NY¶ , â½=.&ïÐ@9íÞ•³g2ÙÚo¿Û7/ñ¦UñÛoÈø”»h)RÔ1U¦ c‚”Ò•c"$­\ºí*z#ÇÆ®‡ÓsÄï´Üó[чrdïÄVhL•i6ð’Cº~GÐÔk­›îFÞeôFÒŒ]¦vÏoŸ‚2$5TÝ)Er7Û‰AÈÈVâ͹r¶“óy—>NÝÛ1~˜–^ÚGrc\´Ö­L“Å/æ×ÒôFÀ;–éžbYFo䨨õ`zŽøVÅo‰€lï=”–•i–4¨÷$^ÛKôú1¥üÓŽÞHš±ë!ÀÔ®üæH‘lWeݼ+'ÃÙÛã*ñKüÞaL^‹Š’ùÕ`ßiYü– ’so—PSiš-~éÊ1#•Ô©cJ·¢]Fo䨨õ`zŽø–{~ûÚªÙ§¶ã›jÓŒfãçÄ£ö¦¤ÈÝÈ»Œ^'ÍÄõ `’vå·©m¨ ÛÖ#î]âõR¤ ™˜|˜o2&F¿[á“éÈ{Ï|˜dQü΀FýlW P,~•i&D¸/ñúž«—cñ§½‘cc×3€Iž#~˪ø|]·ÅÝ^"*€©2M’$Þ'&¹×ó[.E»ŠÞHš±ë!ÀÔíùÍÆ| %Ù¼+‡Þ³$íô.»Û=¿§ÙfÞ%ðonådYü&aH…b*ê˜*Ó䀅Xî“ß´×ÁBnE»ŒÞȱ±ë!Àôñ[–ÛžøèQ±ì.P™&Œ ¯Æ]Θüi'iî^&eôFÒŒ]¦vå7¿”o$(šo¨ŠS9ŽŽMhô@q—1qF¥Ù1|•1­öüNü‚‡.» Ô¦IIJ2x÷•÷û)»yWÑ96v=˜ž#~˪ø ¶·Æ”<™¥¦Ò4aL¶ÖÜU¹hì©—4—¢]Eo$ÍØõ`jW~KÖ÷‘\T˜·kû›4"ÂâµîdŒéEz–Ç7½¦Ñ’`¿í¿ L‹âwŽþíû4$A9"¬4Mº¤ºÆÐ»t`a'Çä§½‘cc×C€é9â·¬Šßäç¤.Fx÷ú¿IS™fÅo?¼K![Is)ÚUôFÒŒ]¦vå·†Ì~ã-ØÜÊz‹sÿOö;ü›ŒIcdDßjüêø&Y¿ RÒÀö´ü7ÇjÓxñÌ|ßÇ4†þz\+Ç.E»ŠÞȱ±ë!Àôñ[–+¿%*iŽÆasA³+Ó캀‘š›1¡†Îj–ïrî2z4×3€)·+¿_wû½.”y³í ùü^Ž@Ä´%~¿žLQ3¥h`˜>ù€)¯V~'F¥R1"¬6¿ä7c¢ØÍ±«œ»ŠÞȱ±ëÀ”Ÿ#~çEñÛ Ë‚}ÝD ©XÍ*Ó„1%V¸½{3·’~ÚÑI3v=˜:=¿)x¯6ñûÔ¸Y`)ä3tC²O@w§¤dBeÃ¥,Ùçi˜–^K†µ¡xYšÆ‹KÈt3&Û%wXy¾§X–Ñ96v=˜ž#~çUñÛWÎêsUÊá•i˜R¦»WÚ«Õ¹’’/E»ŠÞHš±ë!ÀÔ®ü–è‡ý¶Ýñ¾›»Ã¼OC àLñ]k°5%Å+:1Šmç§×‡ÿ˜V+¿½-dÈÀ‰Š))•iÒŒ0§øaL,ØÑ1óUÎ]Eo䨨õ`zŽøWÅoŸW£È*Õ$ÞÒ4aLÞ›ûfL¶‘è%Í¥hWÑI3v=˜Ú•ßÌÉG+Aܸ‡û¾Ä]`"?‡°±¼N弉“mÉÇÊ|˜–^FôOý/ËJÓ¤}³ß,¼Ž´£1å{Še½‘cc×C€é9âw^îùmô5¤(¥HšÚ4aLæ÷©üê “ùnä]Fo$ÍØõ`êT~k6X¡ ~¶%~»¬‹Ñ(g”÷†¼ê˜^ý|S"JóÖÿL«âw|UÀ#ó-çÊU¦ñâ‡âgÚsRî UÍ—¢]Eo䨨õ`zŽø×^Fô¡¯As,OåJÓdJŠæº“}ÉƤŸ)–Eô:i&®g“¶+¿I1IR L›Ý\ÖÕ ˆØ‡ì2&R‰! f¥üÍ~Lº,~ IJ†µFH ³2ÍæÊIà›1ùäøNŽÝŠv½‘cc×3€IŸ#~ërÛAÃ?:’²Seš% ¦›1‘êè$ÍÝˤŒÞHš±ë!ÀÔ«ü¶ ¨‘6ˆØdL~ÔÏÞdÎ8ÁN­ÁŘ²²Øþ^7^¿L‹âw ©íÆS.4¦Ú4+âÅø©üÎïn­ßvôFŽ]¦çˆßº*~³mºì'9Qlå*Ó|áÝ]5q§Qœ^Šv½‘4c×C€©]ùmùí•êb•Ò0ù+§l›±1¾l´¿|wȉ}žz ôž/þ5`Z¿Õ»jzt å””Ê49•ƒßYXö)¥^Ž]Šv½‘cc×C€é9â·nT~ûXF#ÿ‹:¦Ê4aL*Æ„ÔÙÿëo9÷ß褻LÊïýÊ1’qÞ¼’b›bÛ…!drê3íõVʱßH%øÝžßºZù$j&Ñœ ¹ 2MrÌ͘\:©—còÓŽÞȱ±ë!Àôñ[×{~Û®K£½ >(èOÒT¦ c‚ßÊoÛÊ¥ÞþÿÓÈ»ˆÞHš±ë!ÀÔ®üÎ9‘Ï#Èìƒ76+¿£dÉÁ¶d^\³Lþd h|IŒbâ|Ôæ¿Óªø²¡$N&,Ç7U¦ÉV.ˆw—Ô{­uTÚÑ96v=˜ž#~ëªøíÓÚü”Ô6Øáoñ[mš¬f¶ÿÿL°¢mñÛ ë§½Jš™ëÀDõWw1&?“lLr—1ÙûçGr¶v{ü]Æd¸flŸ“ä›§r××3Ï1qîÇFv”=¿KÓlà%¥Ï´g¿ÙÝɱ»‘w½‘cc×#€‰ÂcÄïëóž'M†8CNÞè¿ Ù•i˜®Þ/Æ„‚íý?…KÑ®¢7’fìz0µ+¿EŒódŒ^ÃwSÈÆØNpKüö'çè]yÉv¾ï ¤_¦UñÛøˆfôç„e_ùÒ4É1ŸJñaLòš×Ê1üiGo䨨õ`zŒø}}Þó¤±eÝÖôäµB¶ºÿ]Í*Ó„1ñ»üñ=ó+tªr)ÜS,Ë褻LÍÊïäcT¼…”¥üfå7z1iT*{â÷ëɆiøêl€ñ‹–××3Ï1{é£b´÷Þ7™%0¦Ie²}ý͘P:/ ÒÚÑ96v=˜#~_Ÿ÷BÒ@t„“å³â*Ód5#Î÷”TŠÐ¦[Ñ.£7’fìz05+¿ýw5\ˆ!mŽ÷F¶ >vë˜ìÉÙGÊyã™üMñûúzæ9f[Úd¬‘Ä6äÅEñÚ4¹’bÛÓ»Ž Ø~¼“cw9w½‘cc×C€é1â÷õy/$pŒ^ñ‚™‹ËÚ4cL¶êÜŒ)r§ÆÄ^´ŸvôFÒŒ]¦få·Do‹¤.ó0‡Í—†iAÒëtN7ë˜Ä?'﩯)¦o6Š»¾ž…ãÈ”ÅõM+¯L“rÊø™öì"Z'Ç.E»ŠÞȱ±ë!Àôñûú¼çI“ɧsYGL\ˆß•i¦1Þwå¼ ¤}*GñÓˤˆ^'ÍÄõ `ŠÍÊo¡mýM~½µ•óóÍœ)'òFq6çÊÙ“]àòƾHúÅÊïëë™çØk\›}F¥\Ô1U¦IÛ“^­^ŒÉ¸a‡1ÅøÓŽÞȱ±ëÀŸ#~ÇUñÛ#¡ï(”â*Ó„1%âÆ”ÛmOl“÷ÓŽÞHš±ë!ÀÔ¬ü–ìcÊ‚ä’æ])hðŠôÍÜ|4\Á˜ÑŒoˆS˜?ù_€i¹íIl{%F£Ë¹r¥iœcÉ>Wù0&ÅŽøï^&eôFŽ]¦çˆßqUü¶½"ﯹHšÊ4;1ÑtW~û Õ¾’BñR´«è¤»LÍÊïœÙ¾…¤–ès¥§¨üöUHmG<ï\ò7i —B²Ÿô"fßÒû`Z¿½ædp[¶o®Lã{ ÜŒÉ>¢ÎÉo¼í2z#ÇÆ®‡ÓsÄï¸(~ËëäÈõYoPSiš1&Lw?&[M;â)¦ŸvôFÒŒ]¦få·2Ä$¼S\˜_¥-îÊå”Ô‡ÂDñ9X{ŒÉžlTB™$[ûbËëëYȱ”e Ñ;×9V™&ÃÄ>˜‹1af„í¿Ñ96v=˜ž#~ÇÕÊïdK«ï”ÔûLÿ]Í*ÓŒ1‘ÞSRlÑÕ˜®rî*z#iÆ®‡S³ò[-Ç}ŠGö–­¼y*%DzÝh± ™lX¾žœ¼«A4X³ÍÉ7iYüV’À¨Þ*¡˜Ä[™&ã›|õ»“ý¥=Æt+ÚeôFŽ]¦çˆßqUüFbñù¦øZ^ÿjL¥i˜¼Òù£1Eê0&¸í*z4×3€ š•ß1 eß{Ú&TøÞ},&Mdã[ƸRô‹¸]æðýd¶JÙ¯ÊÏžüÀË•ß^#dd7PŽ0U¦qŽiMÆ;wå,û~ÚÑ96v=˜à9â7,¼Ì ™ü€YsÑÁ²2MSÎøaLˆ¹S.÷Ë2z#iÆ®‡S³òÛ EPÉq ˜¼S ¦Aüðfåw bö WHð¹XÖýá¦UñÁÞx0°’âT®2ÍF„C +ÇÀ¶«­àO;z#ÇÆ®‡ÓsÄoXîùýÍ{‹"×*Ó¤*×ȩ̀»'éÓÝÈ»ŒÞHš±ë!ÀÔ¬ü޶ŸŠŽ£Êˆ:…‡‚1a±m*Ô[ ïvð'{çÌmš¾ L«mOŒîjd¿Nµ¦Ê4Îùfå ¡W` W/“*z#ÇÆ®‡ÓsÄoX­üö&®FË1sY.PšfmOsºG{©:½r®rî*z#iÆ®‡S³ò;zX[5A›Œ)*kôë†É‡Ãl2&{²Ú7áã2³N¹Ú¿ÓzÛ“€ÑÈ_ö;²s¬2ͺ `¾k匋Jo+÷éeRDo䨨õ`zŽø Ë=¿½'µm;’×*ÿMšÊ4aL¾çº“¯Ø¤¹y—ÑI3v=˜š•ßB"Á ù}‰w‡1ETˆÀ)‡mÆd;@ï˜Ñç´u+·*~«ÿ[…RZôü®LÆä“c®ÃØ-ýiGo䨨õ`zŽø «â·E¸L*Æþÿ¶¤¨M3Æ$|ïÿ‰:[9¼í*z4×3€ ›•ßþÒ 7‘Š!æ¹ÒS0¦“·y1P ›•ßþälT+ŠX‘/.÷üövyImi‘RcªL³Öº1|º¤ÆÔCOx7ò.£7rlìz0ásÄo\¿ýîC 1…²\ 4M¾ç侓pê“x+ÚeôFÒŒ]¦få·W]%2|0P%Ù=• >©š²¼d¦ÝS9â«)xÿK¹.–} ˜–ÅoŠì—’³“x+Ó„1ùîöظÓ%•ðV´Ëè»LÏ¿qUü¥ ¶Äzk÷‚1U¦ câÈ÷$^RåÎV/E»ŠÞHš±ë!ÀÔ¬üŽ/²$‘BòŽå{ŒÉþ\ðòˆˆòº¶1‰×ŸœØÍÞµ _eL«âw¶ivÕÑ+eÿSeš0&/ïúeL–„—¢]Eo䨨õ`zŽø«â·âØRa?‘ Ô˜JÓ„11G½V3!wn~ã¥hWÑI3v=˜š•ß“ ½Š|ÄÞcò‘èÈöš08¸ìMâµ'GïÕüÕS9\­üÖì¥ I5­u+Ó„1±Ï•»hîhLx•sWÑ96v=˜ž#~ãrå·ƒ‹>%"•/+Ó”1駃¥Bï®ÞåÜeôFÒŒ]¦fåwÄW¿nòþ´ZJšÿûŸ ˆ0ç >3s“1Ù“5¨úµýj%®·=ñ£I̾?­Úž¦ cbÅ;Çжu½­Ü§—I½‘cc×C€é9â7.W~+ØfÃXQ* ,+Ó´» „›1ÅØ™+Gt—s—Ñ뤙¸žLÔ®ü¦€ÉgâJÆ{6“q-o\RÆô ·Ã˜ÈÏd9h~Í´û"0Ѫøýš¿ílÄ>ŒBcªLÆ”Ho±{QœâO;z#ÇÆ®g=Gü¦åžß‚¶®f¿×•Š­\eš0&ñþÔïß‘£¼@ª•4w#ï2z#iÆ®‡S»ò›È›DΠÌ[ÀôÿS³á2\É-°É˜ˆ80æ×'ý*0­ŠßÉ{-¼€–‹“ßÚ4aL‚ù>ùEJÐÙÊÑ¥hWÑ96v=˜ž#~Óªøm[…¬~ÿ!¾‹ýÿL•i˜r ÷$^/íïåÒ¥hWÑI3v=˜Ú•ß¾‰‹ÁÏylS;Uzþ&ß$Õm?§ °µ•ó'ûP¹˜Ùïò¦oXÒjÛ“¢PÈÞåíµ\ý·À²4M“$‚›1yoNŽ]½Lªè»LÏ¿iUü¶MW¢$Þð¸FX™&ŒIãg®£Ï,j'Í¥hWÑI3v=˜Ú•ß$b&~Mž ›“ZÌÞOØP æÝqKÆ$ÙÛÌy1¾ö_¦Uñ3:̱¦Ú4aL^Ò~3&#„=Æt)ÚUôFŽ]¦çˆß´*~ï¸å¼ŸŠ:¦Ê4^Í((Ý5&¶{é2¦KÑ®¢7’fìz0µ+¿äað2ì˜6S L~mYêe³çw|µÊm}µ\€Åï½ÕØÂ"¡¨cªMÆdÖ}Ù·¹íÓŸvôFŽ]¦çˆß´*~GÑ`ûv¿]U$MišL°ðsš›1öh6‡Ÿvô:i&®g·+¿ý3ª—"%âÝÊïÞ¼2…¨y—1qÊ캰Ï7‘ÿL¼\ùík4pÆ÷Pï?Sašt°‰>•ßòž™Óʱ»œ»ŒÞȱ±ëÀÄÏ¿yQüµo7¶Õ5–U¹•iƘò¯ÆDŒâ7†ŸvôFÒŒ]¦vå·7-Q%Iàâ7ïÊÕ1’Ȥek|ÓëÉ‘ìý²§¾D¿/ÓrÏo!}ÍifŽ…ø]™&=¿|^ü͘²mw;9v7ò.£7rlìz0=GüæUñ[ýê‚wv+ ,+ÓŒ1ÅÏ$Þ×ݶNÒ\Šv½‘4c×C€©]ù‚! ªáÍ{â^Kb¶5œývSò+¼¶Ïò‰ê0-íü`Z­ü¦øj»ü®Þÿ L•i˜ ÄO“Ã0]åÜUôFŽ]¦çˆß¼\ù ömP  ©¸.P›&Œ r¼o~sâÔ©1Ờ»ŒÞHš±ë!ÀÔ®üNA0Ø~U1O•žRc ÁÅXÃb¢½Öºï'+U0NñUÆ´\ùbÎ}Ö{.ÄïÊ4aL ásWNC¯VŽïrî2z#ÇÆ®‡ÓsÄo^¿c|vE ZMâ-LÆ>Œ‰swÿ+ÚeôFÒŒ]¦våw2ΊÑZãÖVîÿþ烪}le°ÍÄ›uL>EKHí3ûjÛ^n{}, ÄëI<¥i˜Œ&ݧr°×Á’ï^&eôFŽ]¦çˆß¼\ùX'Ö²ò»4Íâ§ò›‘:âwºË¹ËèuÒL\ϦԮüöIݶ+°_[i¾¡*ê˜ì‰$û¦¸L¯'£Ÿ^JäèÕߦ´*~gïÎÍÙþ…X^â-MÆdhë˜äQ'Ç.E»ŠÞȱ±ëÀ”ž#~§ÕÊïÌàg¥ö½ü½ÇT›fŒ)áÝ]€™zÃü´£7’fìz0µ+¿“Š$À9 îv° ÉOÖX½ùeÜÖ˜¼?º¡"xõùWiUüŽd¼Ñhå‹–Ê4›Äø~D;¬<]Šv½‘cc×C€é9âwZn{Æ_í}O°`L•i˜0ëÝÁÒË;,ÓÝˤŒÞHš±ë!ÀÔ®üöó¸}´¹·*ßÕ˜D5&`ƒbÂÝ–àh;@ûÔ"|õT.-·=1 K~KIˆ‹î•i6»0|îÊt+¿ÓÝˤŒÞȱ±ë!Àôñ;­Šß¼O8iq*W™&Œ óï©\2hì$Í¥hWÑI3v=˜Ú•߉9W’¨nÞ•‹ —Ò«A¾ì2&f#\É>/üæ•”´*~÷ÛÈ1•˜*ÓŒ1eúôü…0]Šv½‘cc×C€é9âwZ¿É¯…×TœÊU¦ cbHÉ–üÐIšKÑ®¢7’fìz0µ+¿à±_vó»9º_Ç”0²íßtk‹1ÅDòþºì{/Ó²ø¢¬åDÕó»4ÍÓ{ÈÅ›1uO~Ó­h—Ñ96v=˜ž#~§åžß*9‹—ÜD,Seš0&_¨oÆ”;«™Ü¼ËèuÒL\Ï&iW~Û6.ã.Æxò>còó8+¯¢ÕMÆ1ÙNZ•Ì!ñ€I–+¿#ŠÑFû ..Š×¦ cò™éÆ”B‡•Ë]Î]Fo䨨õ `’çˆß²*~}ÍèuOš«~L¥i˜D>ÝSH±£1É¥hWÑI3v=˜:•ßÑKŒì©í>vïÊE/qWY© [[¹×“9F²ÿ±}|óJЬŠßì7÷ɇ舕ߕi6íYÃ/cÒÜ˱KÑ®¢7rlìz0=Gü–EñÛGÖŠÞþ•¥¬1)MÆ”kL’ߊì$ ý´£7’fìz0u*¿ÅOüÁ–áöÆ7½ïÊQÎt[czÝ”gÛi±Ì¯ÿ 0­Šß ~mÐÖ—Tu¨LƤ!~&ñXJt*¿åR´«è»LÏ¿eYü6F,~‹rÊ4cLú™ù•ü0¹“4·¢]Fo$ÍØõ`jW~‹ÏI±Í”ýÊš6;XÚVÎ Ø„¸µ•{=1Äb” ßl­+Ë/söS„jŸÇß«LƤ§=êè˜rO±,£7rlìz0=Gü–åÊo[]m³‰#=¿+Ó„1ÉÝZ×Sè'Í]Î]Fo$ÍØõ`jW~Ûž#¡ˆmä¶» “"®^o;ŒI4"Û¿|$ݼ©ï¿ÓrÏox WÈÆåRÁÊ+Ólv!Æ[ǤÔC/w#ï2z#ÇÆ®‡ÓsÄoY¿½¯tÐloP¢Seš0¦,á®c²µ'vNLrøiG¯“fâz0åvåwãxm*‰¦¼¥º+çv"5æ”v» dŸ(Ç‘ìyiç?S^¿3Øc„Ä6™ÄåâWš&]R!ÒgÚ³u€)ÇŸvôFŽ]Ϧüñ;¯Šß’‚ýÛOpJ©6ÍÓ]üæ§rÝÕ,_Šv½‘4c×C€©]ùmD)¡ñ<ƒhÀ-`rÆä S´åÛ vSDÛH²fÕ¯Ö1åUñ[ȸcfŸó^öcªLÆúy¼ú´ÃÊó¥hWÑ96v=˜ž#~çUñ;û4o¿9áýÅþ&Meš1¦wGÁ7cíhL™~ÚÑI3v=˜Ú•ßš$ªýÆ”sØxé“mƈ ‹½¿înw{²£úùfÛ“¼ÚóüDÕÛCÙR2¦Ò4aLÄáS+g¿B/Ç®FÞUôFŽ]¦çˆßyUüFòòähô?bÁ˜*Ó„1%LÆd«v§Æ$_Šv½‘4c×C€©Yù ƒ´øLÝ8‡‡òTNí/UÉ~ž¶¶r¯'GFûÉd|‹¾Ù] ¯V~'ÛÏFA¿¼Ÿ‹ÊïÊ4›]˜?³ Ù¶]K¼ù*箢7rlìz0=Gü΋ⷨˆ$ÅôM’ÿ{”[š&Œ)½/U¾+¿ßz[I“ÚÑI3v=˜š•ßG`|CЭFqö{“ DjÜí`é=… ›R´¥Áˤ¿LËâ7©¸±}X„¢À²2Ífª~úÊCN½­Ü­h—Ñ96v=˜ž#~çUñ²Oà¶wR(Ê*ÓŒ1ñ§3KÐÎj¦á§½Nš‰ëÀ¤ÍÊo¿@ëCÂcÎ>{c“1ùdïµï­(ãÖ0‚ד#õ MůΕÓõžß@>Ü;ç\^I©L³Ù…ïæÊ¯Á΋~yÑ96v=˜ô9â·®ŠßPÄø«Ä’1Õ¦)câ»*—%bg5ÓKÑ®¢7’fìz05+¿míµÅ¼¥,HÐcòκl‹‹1®˜`—1¡·rò!ià«À´*~Û‚‚É÷´TT~W¦ c2,úeL©7%E/E»ŠÞȱ±ë!Àôñ[WÛž±}!¢ê | `*M³Êo$¹W³l?ÓIúiGo$ÍØõ`jV~CÈ䥨 ·®¤¼æÍzeùAЖøýz2‹÷ZQ朾yWNW+¿EýN³·úPSeš0¦$éÓó+Ro¯^åÜUôFŽ]¦çˆßº(~«OzzUŠ3ñß­\mšÖ1¥ûTŽ5r瓾í:z#iÆ®‡S³ò‚¡Jð‚u‘´Í˜rT0DK>F7çÊÈå@1’‘¶oV~ëªø-èEBòšï¥0•¦™ÆàÃÊíWè°è¥hWÑ96v=˜ž#~ëjå·Ÿ©OGĨÅuÊ4^Í8üT~ÇwÓøVÒ\åÜUôFÒŒ]¦få7Ûϲ*á¼;%Å'/zãñ²ñíS9ÈF™¼CÁ|ð¿ÓrÛãn^Zåsþ– Ô¦c ×µ'[UºÀt÷2)£7rlìz0=GüÖeñ[8ûPÕÈÕ\ùÊ4^Í8&þÔ1töÿ¶Îý´£WI3s=˜¸þêÞŒ)kÒö¿²Ç˜üÄ?CN¯Cÿ]Æä SR"ô&Vߦëë™ç˜¨ÏdzõÅ03Œ©2Í4&øt°d?é䨥hWÑ96v=˜8ïyÒøÝ ß9` Å””Ê4cL÷þ?ENíÊo—¢]Eo$ÍØõ`jV~CWi²=mˆ[Àôš7k+$¶]EàÍÊo{²``ŸÞðM`Z®üf°Å…ü”[¹Ò4;•K|3&Ë·ØÖ˜8ÜåÜeôFŽ]¦Çˆß×ç½49G[›m%òŠ›¿IS™&Œ (ßuLöb…cºË¹Ë褻LÍÊo{g\÷öþ›a³òÛœ»¤–YíEܦדÉg€m$sø¢Æt}=+9&Lˆ.à¤zoaš0&ÅÏ}LÛØÇv3Bw#ï2z#ÇÆ®‡ÓcÄïëóž'O{õùgä-ü ÆT™¦ÿ2¦Ð­Ãá*箢7’fìz0µ+¿#ÛnÖuž€2ßPŒÉ·‘’„¨ï#½­:&¯ûö¶¼>Cë‹•ß××3Ï1±¿|’2+…‚1U¦ cRùôübDí1¦KÑ®¢7rlìz0=Fü¾>ïyÒä >^b(ÅïÊ4Ó˜Þ×_Œ)¾[ ¶’æR´«è¤»LíÊoðÉràÃ×rÆÍ))(ê„É2Ñ&c‚(>Âh&Røb¹ÀõõÌsL0û°%À· ù`ªL““ßùØH¹}ÀÂáR´«è»L¿¯Ï{!iümo³èÓ$‹Õ¬4M“ï@>ŒéÝ4®‘41ü´£×I3q=˜b»òû5 ]0Á^¹€3&ã†Ãk¨.ìÖ1Ú7ÁÑp#åy‹º¦¸*~³yà—ý=`©M“Z¹¨ás»À{šwrìR´«è»žLñ9âw\¿Á!cü”|¼â_ÆT™fŒ ã]•›‚t¦¤p¼í*z#iÆ®‡S»òl 'â›±¼Ù BŽÎ—ìç9Óî© mHò«Î2ÒWi¹ò[0hòS-šÖ¦Ù´g€cbáv¹€eâO;z#ÇÆ®‡ÓsÄï¸>ðòýu`SSiš1&¾ÄocL;=¿mÃ÷ÓŽÞHš±ë!ÀÔ®ü6@JÁk· œæª²ŽÉþØ$¯&‘†M»“Sse8…ojLqUüN¯£xßbÆê®\iÚaL¡3WÎèâO;z#ÇÆ®‡ÓsÄï¸ÜöHlö2ãroešÊ é͘ RGüŽw/“2z#iÆ®‡S»òÛÒ;·8N>¿i·ò›ÐïËE~é»§r~×Ë¢#Ë7'ñ^_Ï<ÇD²Ú¾òuR ÆT™¦ŒéS+Ç~âÙɱ»œ»ŒÞȱ±ë!Àôñ;.‹ß9“B¢Xt¨L3Æ$ò™’¡'~Ç[Ñ.£7’fìz0µ+¿Å!ù1ôÞ0‚ÿ{^Û6Œ3ÊÞVîýd{Â7ÐyÕ¦å¶'¶Nú\$Û{år|SišM{¦ßÙ…‰:ã›8Þ½LÊè»LÏ¿ãjå7q ‘m«$)Œ©2MÓgoйÓ]á*箢×I3q=˜ ]ùm*ïZâZ*ow°òi¶…õër[å¯''T5 ÷ú/v¸¾ž…3ŒM®µû‹ ³2M“7ýþ0¦, ®FÞUôFŽ]Ï&xŽø ëmO(ƒxáSY`Y›¦§rŸß±?Œ€áÓˤˆÞHš±ë!ÀÔ®übÆì厴Û)'Ga{ó]&Ú­üÛR6pbé‹­u¯¯gžc’|[ ÙvK)•“xKÓ„1}N~Y vä¸í*z#ÇÆ®‡ÓsÄoX®ü¶5ݨ%û™²çwiš1¦„ŸS¹ˆžß w9w½‘4c×C€©]ùmûÚh”E½ÅÀî©\dûa‹ón?&{rŽÉ€ÑK¿¿)~Ãrå7Û*±Á%‡Bü®LÆdû¬Ï]¹,))–%?íè»LÏ¿aUüöù£~qK©2M+¿ã§“bï(.E»ŠÞHš±ë!ÀÔ®üöÚJH1±Q¦ÝI¼Lâ÷‰mK¶W`ùz2CF?,Ð(ß¼+Ë=¿cĬæoÛÓ¿9V›fŒIõ“c‚Ú˱»‘w½‘cc×C€é9â7,‹ßIɇJ§Š))µi˜ð}JòfL½­Ü­h—ÑI3v=˜:=¿ý2 /ÁFÝfL(ÙçUR$ û§rïÊ RIßl­{}=óñ‹b¬$J9†¾2Í“äOSw|Ã¥hWÑ96v=˜ž#~êøüdß[ÀÚ.ûï‰ImšiLÄ÷‰‰÷_윘à¥hWÑ뤙¸žLØ®ü޽_Jöžˆ»uL$@‚,/akDøëɶÿÓõUþE`Âeñ›%…Þ»½8•«MÆÄ˜?=¿m©ê0&¼í2z#ÇÆ®g>GüÆUñES²uB}Ïߤ©L3 þ3W®«1á¥hWÑI3v=˜:=¿&Û$¿¯¶×Z×þbõV/ŠI"¤°}*—è%½·ÈüÍr\¿ ]³…–€ÅÉomšö•Ÿ:¦œC‡•#þ´£7rlìz0=GüÆÕÊﯙmäÔ¿8Ê­L3É6-Iz,ñ*箢7’fìz0µ+¿ýºš„™SÞ¿_Œ) ýùÞä\^ ¶4&[üÅщIõ›—xqUüfö–wöÖ{Óƒ¿ÀT™¦}åkåB’N%òO;z#ÇÆ®‡ÓsÄo\¿1Ø·’la/‡T¦iwxw`ÐcLé§½‘4c×C€©SùíSöÿè<”Œ rã=/j{®ÙO&ÊmoòÍÊo\®üöi¥”Õ¯”âJÓ„1ùþö7Çz]Rñ.ç.£7rlìz0=GüÆõ—öê`ô*@.Žr+Ó´Ž)î1iÎa?S,‹è¤»LíÊï¨ÌÁ¶½ÇímžÊ‘$Œö§cØž+§É{¾ƒú¨Ú/Óªøm»ZåÄ>~‹ÿ²òÚ4cLò9ùõAý»í*z#ÇÆ®‡ÓsÄo\¿Ñ^0›"J±•«LÓîù?ûÿÞKºí*z4×3€‰:•ßb/pÖà³ÛÁÉKT“í]y¯íÉëÉÙGÊù@"¤ov°¤å—>àÆP6&-[ëV¦Ù$žô{3 örìžbYFo䨨õ `¢çˆß´\ùMÞñÁ–Y¿ûô˜*ÓLcz÷ÇyÏ•ÓÎ\y¦»œ»ŒÞHš±ë!ÀÔ®üŽ)RJðˆ'›wå ²×’f[^ÂVåûÉê÷[•!à7OåhUü¶M¸‹$1Œ©2Í5¦ßZ9é±rºí*z#ÇÆ®‡ÓsÄoZ¿Í—_-ª±¼Ä[š¦=¿ãÝó›ý’X'i>Šv½‘4c×C€©ÓóÛ7 ~Ó½Åív?¦@1!!º„¾Ë˜ìórlJÞ&ý›[9ZxIlKš"—ÓžkÓ„1iø/cÊÊoº§X–Ñ96v=˜ž#~Ó²øíW„l·Ž˜c±•«L3ÆDpÿŽœ©×(ŽnE»ŒÞHš±ë!ÀÔéùíõ äÝ·q¡][y* ”¼¡“×#ïÞ•‹)¤l;’ÈôUÆ´*~{Û:1˜½z±`L¥iƘ8ýê˜Ü¦KÑ®¢7rlìz0=Gü¦ÕÊo‰Š¶BKpéï/0U¦ù]¹Ï=&•Έp¦«œ»ŠÞHš±ë!ÀÔ©üF!ãK1%ÉÝ:&æÄv-È ÃV¹ÀûÉ9úTäבÁ7iQü6ÉGí rAešÊѧƒ;3ìä˜þ´£7rlìz0=Gü¦å¶'‰½ÏÅ¿r®\ešÊéê˜4w&XðÝˤŒ^'ÍÄõ `âvå·áƒyýµè|CU0&Û7È~yw¯—~+±· ׯXòòÀKVLÆ!ÆâÚSmš1&÷$ÿ|:–|O±,£7rlìz0ñsÄo^ïùí³‘sP5Âó˜*Ó”1¥{ÿo4»7ð’?¼‹è¤»LíÊo¯nð9))‚Âf?¦,"¦WŽP­“ MÆdOöm\š¼[ßiUüF#W9ƒŸzÅ¿9V›fâoŽiì\{âKÑ®¢7rlìz0=GüæUñÛë7³ ”wåJÓ„1!‡ßª\ ½¤¹í*z#iÆ®‡S§òÛÛ”:{qò¸Å˜¼ý¤ãQÆ^?¼ Lï'½fG1|õTŽÅï öýEôÍÅ¢çWeš0&É¿'¿F'{‹ÿ´£7rlìz0=GüæUñ½ “·®-“¦0ÍÓ{Î×{5K½£\N?í褻LíÊoò¡±1ù}.ÏÃ-Nåи¡zqe²ÝqÚdLöädÛ£K1ë7û1ñªø­€9£7ÆPÞ•+M3Æ$ô{ò«Ú¦KÑ®¢7rlìz0=GüæUñ›“k¬¨ì#=þSešiL>ý˜³­§¤¹í*z#iÆ®‡S»òÛk·YÔ¯½åùÙØ_Æ„ ÙG¬ø†X’m0&ÛütµÄ(ÅWçÊñrÛô–ªä$²¸Y›&ŒÉ>˜ß:&M=óîeRFo䨨õ`zŽøÍ«âwHAl]÷žbEwÁÚ4Õ˜è?÷˜ “4)ü´£×I3q=˜R»òÛÀ4FN~5ö¦¤üßÿ2ûh¸d{@ÍñE·–éýdŠY¼!1}µƒeZ¿ÅÖÉäM¢¼ LL¥i’cá&¯cRéˆßéR´«è»žLé9âwZ¿GöG!ÅbAešV~˧ŽÉ¨q§ò;ÝŠv½‘4c×C€©]ùí¢·èd`_‚÷ÊÀ[–˜CF…WÛî)E4îjD͘¾©1¥Uñ[R” F¢¡^™f9öÞh½§=cï¢xºí*z#ÇÆ®‡ÓsÄï´*~Ûî:©! e-V³Ú4»+øé.(H&^éR´«è¤»LíÊo¯^Rï¹i[«ù¥¢\À6pY8K ønM°£1Ù“Uý¢ÜÂ-½¦ÕÊoò¤9""—Ý*Ó,ÇTnɇštê˜ÒUÎ]Eo䨨õ`zŽø–Åo'į)hZÖ1U¦éj†ÿé.Ø+°L·¢]Fo$ÍØõ`jW~‹_ÁUÛ}ƨ°¥1¹øíŠÛ†ŽÃ.c[ú³1‰Ã7§¤¤UñÛòÂØHŒ^-Zt°¨L³{wF}3&Ò0]Šv½‘cc×C€é9âwZîù öîx¯ã°ÅV®2MW³ô9•3ŽÓ9•Kw#ï2z#iÆ®‡S»òûUy-Ñâ¼Lÿ÷?4PJÉ/ã æ°U.ðz2Ú†‘õUŠÿE`Z­ü† ÂÞ°=–wåjÓ,ÇÒfB¯ƒEÒŸvôFŽ]¦çˆßiUüön".Ïf.Siš˜°|ªrB˜äR´«èuÒL\Ï&iW~gõb@A[×cÚl{ˆlŸƒw¢Ì›ŒÉg}y[=û>¾Y`)«â7L&ôÙm©<•«L³Z¹7½§=ko®œ\Šv½‘cc×3€Iž#~˺øíwÐ" ¦b´Nmš˜$øÜ•3¾ÐKš¢]Do$ÍØõ`jW~g±œ·cöy@[Œ)Ùß*öÖð¶¸É˜ìÉ >íCyMoéý 0-‹ß _Á(j9%¥4­³rcL©—c·¢]Fo䨨õ`zŽø-Ëâ·rÈÂl£T\â­L“Õ,ÄÏjö:%ï$Í­h—ÑI3v=˜Ú•ßÞ=Rý ÚÙÏ0…ÿå×Þì-ô›ª›ŒÉk[…’o‚ï2¦uñÛ‡wz«_(&ñÔ¦Y­§û=H¶ÇïXÊGÑ.¢7rlìz0=Gü–UñÛ/=Ø×¢˜ ©2ÍÓ»4í=W>uiö¥hWÑI3v=˜Ú•ßj¨„¶£&§L›ã›²dÎ1€Qž@qKü~?Ù++s²½ Sc’åžß>¨ÑçxbqW®2MÓïì ҩ•“»‘w½‘cc×C€é9â·¬Šßà“‘üL[”Ê{L¥iZ•K¿Œ)rOcºí*z#iÆ®‡S³òm_kxÊLq~1äoÒh r²/‘ †­K¼ï'ÛOzÏ3]üM`Zîùík"¨@q» 6ÍÀÝ)EÿlÚ9v7ò.£7rlìz0=Gü–Uñ;z·ÃhK³-E¯œÊ4»Ç”à^ÍØ¶ë:¦|)ÚUô:i&®gSnV~%IcL~Ug“1©S¦—ËA7»  7F ³ÂWû1åå¶'`N}¨CQù]™f· „5&ãl»{™”Ñ96v=˜òsÄï¼<ðÒ;%M¹¨1©MÓ^9ŸFˆ½¤¹§X–ÑI3v=˜š•ß5) —Yæ6“Ÿ«çñfÂ)½HÏcŠê“®•ÈK¿¾y%%/÷üƬÙþ(¥ÌÅ%ÞÊ4;•‹ü[ùm?Úɱ»‘w½‘cc×C€é9âw^¿¼{m®½r±•+M³ ü«1!ÇŽ0™é§½‘4c×C€©YùmÀLöùÁ½–Ƙ|b‡±C0pÙ*x?YÈ~Ü‹ç} þ˜VÅï¬JQ_÷c!~W¦cºågL¨:¦|)ÚUôFŽ]¦çˆßyUüŽÞMÛ’B å©\išõʹÉ©Ó)_Šv½‘4c×C€©Yù^{O|(o1&‘A|òBYwÓ«*øøFýæ0‚¼*~çQü‚qq³6ÍÓûÊ»Ž‰±ÇÊ/E»ŠÞȱ±ë!Àôñ;¯Šß 2Kö·>ç²Q\išÍ•§øÑ˜‚JGüΗ¢]Eo$ÍØõ`jV~£-íL^JL1ívHä“ ÷ ‡ÍÊo²/eŒÞ^è›À´*~gC@ÑDŠK¼•i˜Â]+gKUï®\¾í*z#ÇÆ®‡ÓsÄï¼*~ÛŠž¢ß_ôCù¿ÀT™&Œ)ÑuÁÒKºWRôR´«èuÒL\Ï&mV~Û¶3ÅdŸBV¿\²Yù]ž‚ä#V‚nÞ•ó'ÕzÏ ÿê•]¿‰¼þ=P¹¿+ÓìTñw/ÅN¹€^Šv½‘cc×3€IŸ#~ë²øýºö` 9§TT~W¦Ù ý’¤­œÞŠv½‘4c×C€©Yùíã9Qc?‡Þ­ü6¦Cªà#°˜pk+÷~2SffR™Câ¿Ó¢ø£7‡3‹_ešÕ1qþÄófè­ßvôFŽ]¦çˆßº*~Û 1hVï°ñ7i*ÓŒ1qüÔ1…œ:4[/E»ŠÞHš±ë!ÀÔ¬üö«}F)8‰Qž]Æä3Ÿ$¹DEÛuLödñ–¼Þºh^¨ð/À´*~Û'à]†“$àBü®L3ÆDô˘ ×ó[/E»ŠÞȱ±ë!Àôñ[—+¿³C¢w‰æb5«LÆd™úYÍBìݕӻœ»ŒÞHš±ë!ÀÔ¬üF ÙöbXýꙿ×)ljԢd?XKŒ }QHÈ!½zÏ|˜VÅo£n>ü~qqW®2Më˜Âoå7õŠxõR´«è»LÏ¿uUüFMd¯€$ïÁUSiš1&üüŽº½rôR´«è¤»LíÊoÛËf[„}ÜPN›mOb h~m±5ŒàýdõŽ9Ù?¾YǤË=¿ƒLì÷~ËK¼¥iÚI~gB—•ß¼Ëè»LÏ¿uyà¥Wâ±!‰ŠËÊ4;•ûÏ]¹€™_¶?ùiG¯’fæz0¥ú«»4¦ÄÞEÒçÍ))öSêEÈšBòô»SJÌ‚2}³òûúzæ9&™ ý·ŠªNå Ó´KêçTŽ3uF„§ÚÑ96v=˜RxŒø}}Þó¤ñ>fICµGQ.P™&Œ‰ß—*ߌ)tNLR€ŸvôFÒŒ]¦vå7x# #xb¿·l“}’ä3À œòVÛ“÷“ý£B&?œû&0­Šß¶J±7Î  `ªMÓ»rŸÊoŸ!ÓfL)\Šv½‘cc×C€é1â÷õy/$M´í‘jÛúŠeÏïÒ4aL¶¸§¤’½Píë)ܽLÊ褻LíÊo¤ìõzø=½Û(ÎO¯¢÷NßeLödä‹ÞܿʘÖÅo²]’ý:)èßû˜µiVÇÄ׈pטr§»€í„ÚÑ96v=˜#~_Ÿ÷œØ[ünE»ŒÞȱ±ë!Àôñûú¼çIã[k&¯IÉY `ªLÆ~¯ëbL,Ü[Íî)–eôFÒŒ]¦^å·w6ˆ‰L¼y‰7ùˆ¾Ä1¢&´[ùÍNÉïñ|•1­öü&fòÞµ«‹â•iƘÜ:¦n×1éùiGo䨨õ`zŒø}}Þ+Ic[†à-E²es)~¦ c þ^Œ EÚmORü(ÚEô:i&®gSlW~#ÙîÓh)JÚÔ˜RJä%Î2âvå··‡QãK¶øgø&cŠ«â·+ñH˜§r•iƘð÷®œíð;Œ)^Šv½‘cc×3€)>GüŽË=¿ÉöI¤¼ÿ/0U¦ c ü™ÄkßpOüŽw#ï2z#iÆ®‡S§ò[£*¡‚},óæ#còá‹¶ 4Öôº ±É˜¢½¿~‡ñ‹uL××3Ï1aã!!&5¶S4#¬M3Æ$z똶+Ðv­œÅŸvôFŽ]¦çˆßqUüˆ“rJ9Sq*W™fŒ)~Nåȵ×NÒ\Šv½‘4c×C€©]ùÑ~×€ˆ¶ûÜ-°L¢œ³…{í-vû1a6<£L"ñ›#¯¯g!ÇbB_W(ø9eqÀRšfuLù3‰—3u.ñ"ÿ´£7rlìz0=GüŽËmO²ÚR!€ \žÊ•¦ñj†úîý÷bLÀ&^)Þ½LÊ褻LíÊï¨Kìß²=ŒÀ­EòK<Ç »,5EÛ‘4ÙoðÅa××3Ï1IÁ@Z`¡cÖ¦cŠŸ––aÒјâ¥hWÑ96v=˜ž#~ÇåÊoÿ:,‘c*ú1U¦ñj†9ÿjLÞ·“4w9w½‘4c×C€©]ù}T7zï<#’›Œ)û¤MÙ'õÙvØÏú½Å Æ/¾ L«•ßöýùè?¡BcªLÓ»rÿaLŠ=V~•sWÑ96v=˜ž#~ÇUñÛx±¯ÍÊK¼•iƘbŒÆ°³šAøiG¯“fâz0A»òû5©†mOe»Ú¬c/}ò˜ö¢ïv°|5½Qÿé óóÀ&X¿³ýFàK‹¦·\ýß’”Ò4›Ä“Ã}òËÞÛ¥“cñ§½‘cc×3€ ž#~êøïûÉ/Û’QLâ­L3ÆôžZñbLACg5øiGo$ÍØõ`jW~2Ö*c°ÍÁ”·Œ ¤Ùþꂹ;%Å>$P ¶„¯žÊÁ²ø‚maõÂÑBü.MÓ»r|¿l`Ò¹’·¢]Fo䨨õ`zŽø Ë=¿mDª‚Þˆæ/0U¦ c²}ú}ó› I:ܼË褻LÍÊoPQƒ/NÖ¨»Œ)ãe\ˆ÷Z뾟Œ†iÁ¶½ª_ìù}}=óßÎÈâ›ý˜*Óì®ÜoK|=®•cŸrî"z#ÇÆ®‡ÓsÄoX¿É ¥èR‹ëµi˜á]c‚ö=÷hö¥hWÑI3v=˜š•ß †Íê,Ïèžl¼zµx 6¯¤¼ŸÌÉ'Òù4ßoŠß°*~{iO;G ÆTšfÓžsþtIM¹w».E»ŠÞȱ±ë!ÀôñÅo`æ'?†*!mO+Ó„1Ù×zטøºÓcLù§½‘4c×C€©Yùm{)PŽ9îmå‚SLˆ’‘óö$^ÄcB¦Œ_eLËmOÄç¾z¡lÙö¤4ÍÆ;ÇX Ó¾9ÁÝˤŒÞȱ±ë!ÀôñVÅï„Év`ÁöØÞUìcªLÆDésW“r§ø /E»Š^'ÍÄõ `Âfå·J¨^œl{²Ý:&Åè­qæ­r÷“s$Í1ûUÞ/®V~ƒ—z„Wkäb }mš1¦(¿Óž5tN~ñ*箢7rlìz0ásÄo\¿“m6(e[SìÿkÓ„11æÊ£trñR´«è¤»LÍÊoHl{1TµL·TÚé. ^aiœ‹É§?m2&/GŸ šü~Å7i¹çwVoõ—´¼Y™f}å‰ñfL ½~Lx7ò.£7rlìz0=GüÆåžßöŸ„¶`Ø–½Ò˜ ÓŒ1åÏ$^”ÐFhû½ŸvôFÒŒ]¦få·Áƒíá¼õÃæ©)AŽJœ¢×ûm2&{2ú,_/îüªÆ„Ë/ÿiŠŠ1ôµi6í9þÖ1!a1ÝS,Ëè»LÏ¿qQüö¥9:'ÉFwʹò¥i˜>U¹è·P;I“~ÚÑI3v=˜š•ß^ šsÄd¨ŠaóT}–%¿Oj|kó®œ=Ùï£"Šñ®¯Þ•ÃEñ;oh ®ã¿ùÎë˜JÓlڳњ›1y§’NŽÉO;z#ÇÆ®‡ÓsÄo\­ü0kï_ªÐïÊ•¦ c w¯©ÞK¼Ê¹«è¤»LÍÊo`õn¾ÝðÛr›=¿%IŒ)ÀkJÊæ$^rbo÷-¶‘üâ$Þëë™ç˜Øzaôòª¢Seš1&ÄüaLŒ½­Ü¥hWÑ96v=˜ž#~ã¢ømlÄ6ÕöþHâJÆT˜&Œ 8Nå.5¨‘4~ÚÑ뤙¸žLÔ¬ü†WÝ·‘&!ò{{ã›ÄÀÌÿü”^µ´Á˜ìÉÉûê'ð¾)_&Zîù­I/“-¶r¥iƘ?Œ Sg|S¢»‘w½‘cc×3€‰ž#~ÓrÛ´ÜW! HE¯Ê4aLAÃ=Á¶êÐi{Bw/“2z#iÆ®‡S³ò˜Uú o\o˜¢}–Ê)¨ñÄ]ÆÄš³÷ÎŒ ¿9%åúzæ9æ­8íÍíiµ`L•iƘ„>}åñ­i¶rì*箢7rlìz0=Gü¦UñÛ[c‰dãå …ø]™&Œ)¼ÁèŘ€r§Æ„.E»ŠÞHš±ë!ÀÔ®ü&2¶c¿.Ûw¯¤Øv%ûlØ(ÑK475&{rD™¼Ã7ËhUüöí ‚^ôYX–¦Ù$ƒû›1ù]¥NŽñO;z#ÇÆ®‡ÓsÄoZ­ü6k߈·Ç’ò(·2Íê½ÿG¿ŒÑIš«œ»ŠÞHš±ë!ÀÔ®ü6ÎHh›Ðä[ºÍrÛ{ñ¶ØŸüº ±Ç˜ìÉþÎc˜×œÿ 0­V~‹ý9HÑÞ~ŽÅV®2M©~:X(÷Šxé*箢7rlìz0=Gü¦Uñ;f¶ýöB1¾¹6ÍÇ_ÆSOcÊ?í褻LíÊo‡i/ Jœ§¼å/cò;n>A- (¦­—דmI¶§{OËü0­ŠßI¼Y0ªÏ-û1•¦Ù´çï:&¦ÞìBºí*z#ÇÆ®‡ÓsÄoZ¿) m6(#ÂkÓx5[¢ïŒ¶‰i' ߊv½Nš‰ëÀÄíÊoƒiA )«­Å[SRÂÿÐëj e È›“x_OÖèÓ®¼I݉WÅïä=E”Ð[¶9V™f³ ?,T{Å9þ´£7rlìz0ñsÄo^¿Å,†Hh¸RÔ˜T¦ñj9}¦¤¢·„ê$Í¥hWÑI3v=˜Ú•ßÞ::úaòj‡Í¶'I\ô¶wŨÓvwrBF±·˜¿¹•ãeñ› iýòŸau¡1U¦ c2Ç[c²}}g }â[Ñ.£7rlìz0=Güæå¶'b6Z&CÅV®2ÍSÌŸ:&ïÖÓIš»—I½‘4c×C€©]ùý2­Úÿ„ì7÷N傽^Ãxãë¢]'•šŒÉŸœ’OñŸþ 0-W~û€;{å³Tså*Ólv!çc²­W˜îrî2z#ÇÆ®‡ÓsÄo^xiL"ÚòZ^I©L3Æ„ùîùmÔ†z[¹ÏË"z#iÆ®‡S»ò; ïmX² jò6–y˜ÞO6O†ˆD_­üæå—³}uÁ›ý[¹Ê4cL1ü2¦H½­Ü=ŲŒÞȱ±ë!Àôñ›WÅoò£®È~¶] #,MÆ$ïYrþ;‚†^w¾í*z#iÆ®‡S»òÛIkAñÑ.{Œ ™É‰mSöªcÚaLþd¿hG€Þä‹À´*~ç½bTÔ·Jc*MÆôŸ–d{Ý+ןvôFŽ]¦çˆß¼Úö$³¥q𺵷”ø`ªLÆ$1Ý=¿]ªîœÊ¥«—I½Nš‰ëÀ”š•ßQ3EÖð‡ÍFq‘!uÖ¯aºŒÉŸ ÁH“m| ¾y‰7-÷üVÿâ²OX(‡ªV¦ÙìB¼ä/ÔYüÒÝÈ»ŒÞȱ±ëÀ”ž#~§Uñ›³Ÿjû´ Å]¹Ê4aL)î1A_˜L—¢]Eo$ÍØõ`jV~û %!°LGôþù{Œ‰‘ƒ&q!V`k+w=³“*}õJJZ¿½ŸHð3Fþ;ð¢6Íf¾x½gfîñ¦KÑ®¢7rlìz0=GüNËmO‚y‘õãßr+W˜&Œ)Ý—x}[‡]`º{™”ÑI3v=˜š•ß¶—ò‰¶G†½­œý°mÆØVp±Ÿ†]Æä„ SHê=ÿ L«â·wJH>É ±¼Ä[™fŒ (ÜŒ íãé䨥hWÑ96v=˜ž#~§Uñ[]$õ~"9—âweš0&V¼GmÖ£Ù—¢]Eo$ÍØõ`jV~ÇŒAGJ²W`þ÷#@Æ•"A‚MÉŸlÜ•£aSžw‚ú`Zxi[Sû;8*ä‚Ú4›ÄCp³rrJÚɱ{Še½‘cc×C€é9âwZ¿ÛÊ1§±xY™¦Œ)ß«™3¦Î©\Ê?í褻LÍÊoÿ¥1d}ÉLÛmO¢ª÷K‰>Õa“1ù“Åö¿ òͶ'i¹ò›¢btÆ‹„%0¦Éí‚Ì¿§röÓ½»Ë¹Ëè»LÏ¿ÓrÏo[$ì ‘ `ªL3ÆÄéî.‰{“xånä]F¯“fâz0I³ò;Ú&ŒØ7S)Áüо`L|ޝ·/Í:¦×“£ßà ~ñë‹À$«•ßlŽ7§2ò ©2M“`¼kåÈþNŽ]åÜUôFŽ]Ï&yŽø-‹â·-:‚$>Q:Å’f—¦ câü«1Ù/Ð9•øiGo$ÍØõ`jV~G ÉörB¨q·QœräÙQÞeLþäW1SP?ùþ"0-‹ß!Rðr.A)»¤–¦cú+G1ÆŽ\ ·¢]Fo䨨õ`zŽø-Ëâ·÷­µÁ˜l**¿+Ó„1QàÏ©åÔiâ%·¢]Fo$ÍØõ`jV~Çd¿rÛ| {SR¼ ¢ ["ôr¿=ÆäÝôlõϯªÔo– Ȫø ö¾û•d§pÕ””Â4cLé·ŽÉx:9v)ÚUôFŽ]¦çˆß²<ðRįš²Wäwå*Ó„1Ñ-Lú¶z7¿åžbYFo$ÍØõ`jV~ÛvÊåoï—‡¼×óÛ>½‘ 0Ø>v÷T޽Ü9‹aâü<ð_€iUüFÛ•Š½ï>ç¶¼+Wšf“xîîöƒ=ñ[.E»ŠÞȱ±ë!Àôñ[–{~£€‚í72aQ.P™fŒ)éÝ]˜¨Ç˜îFÞeôFÒŒ]¦få·m¥ü*mRK÷°;¾ ¢mY3yçßÁn2&{rL â'ßó¾ÿL«â·Ÿ¨f4™3SešMâ r×1aJ½¹í*z#ÇÆ®‡ÓsÄoY¿mÿås_mï€ÕV®4Í4¦˜ïîÀÚÛÿçðÓŽ^'ÍÄõ `ÊíÊoÃÒø*E²mÕîˆp° \ô²WQÂnå·Ï¹ÊA)Iü¦ø—{~µQHš¥¦Ê4aL>^éfL,=¹ ß¼Ë軞Lù9âw^¿5ùá†&Ñâ(·2ÍÓ[ð~3¦w7ËVÒÀO;z#iÆ®‡S»ò}°+Èëz·»€·ÄÍH˜sHAÓ&crHïßíÉ_¦Uñ›³H€ ±¼Y›¦Œés*‡‰C˜.E»ŠÞȱ±ë!Àôñ;¯Šß|¨†Úwœµ(°¬LÆ„*÷þß¶u¯Çµ’æR´«è¤»LíÊo A‘ R·®¤ø™&ÙFÌqðe|³»€?Y²Bê×7iUüGZÌþ-wåjÓŒ1Åô™]ÈÜë./E»ŠÞȱ±ë!Àôñ;¯ŠßFm(ØŽA©¦Ò4aL˜?SRP;'&ùR´«è¤»LíÊo`¿°h;ñ9J›Œ)±·ìŽ>†¶ë˜ìɽ’-Û˜Ö{~ÕÍ’É^ú‚•W¦ÙìBæßÙ…;מò§‘w½‘cc×C€é9âw^¿“wbM]*Nå*ÓŒ1%þôc"èÒìKÑ®¢7’fìz0µ+¿½õfðQ'2ŸUR0&?RóQUYŒõlÓëÉ’ Ù6t_fL«â·( röŽyeûæÊ4aL1óGcò†Ë»í*z#ÇÆ®‡ÓsÄï¼*~#²9ÛBa»ëâT®2ÍÿžÊ٦ØôR´«èuÒL\Ï&mW~Gû/»RÄó‹!¥Æúñ ¥½rד“¢÷bðÙQß<•ÓUñ[™Q g½Rèïí‚Ú4aL^¢}3&ÌÒaLz)ÚUôFŽ]Ï&}Žø­«â·dô{Y9'(îÊÕ¦ cò–®7cBê5Š×KÑ®¢7’fìz0µ+¿£íl-ݳ·)Ÿ×_Œ‰ÔÞ±ŸÕ¬{­ußO6vé]ÏH¾:Œ@Åï½Þ!Ôò¢xešM{Öß¾ò¶eí0&}+ÚuôFŽ]¦çˆßº*~+šÁ_Ûså*Ó„1EÄÆä½J;Is)ÚUôFÒŒ]¦vå·Ÿ§ùL Fõ©Ö{ŒÉè’s¦Ä>Vˆ6“ß…Q¦ ‰¾ÙI×+¿#g%ˆé=¢òOåwašiL?ŒÉ6»¹@?åÜEôFŽ]¦çˆßº(~‹BNIÅKñË£ÜÊ4cLðÙÿ¤ÞøfM?í褻LÍÊoõ†ˆÞ䑽yI\Çx:‘Àb8gÝ*°|=Y‚"Œ^(?ùá¦Uñ;û1|ò¦¦F~ÿæXešiLõfL¶eíÜÇÔKÑ®¢7rlìz0=GüÖUñÛ«7|á%» ˜V+¿I}K«Y©8`©L³Ù…ï2”÷ì¬mSÂUÎ]Eo䨨õ`zŒø}}Þó¤ÉĤ,)€·Pú L•iƘ„>•ß~ŠÖIš»—I½‘4c×C€©Yù-H²0{··¸©1Eõá()!HļñÃø~rˆ \ÎM_Ô˜®¯gžcâ§Œ’í/‚”‹»r•i6»Ò§»@ÜÖ˜ ”ÚÑ96v=˜#~_Ÿ÷¦²û¿ÓrÏo?žŒ!y˜j+W˜fŒ‰…>ŒÉ(S'ÇîFÞeôFŽ]¦çˆßqUüFö~µ¶¨{íë_`ªLãÕ,*~Ǩ½¹ò/E»ŠÞHš±ë!ÀÔ¬üN~ɈD¦À›ŒÉ7c-® ë0½žlÛ^ŒT‘¦=Sþ˜VÅïèk ÎǦE¼•i˜rúíù5¦KÑ®¢7rlìz0=GüŽË=¿=}‘C¹šÕ¦ñjm•¾5¦¨¹Ó(^âÝÈ»ŒÞHš±ë!ÀÔ¬üfÉ‘9{K喝ǘü®…Ÿ‹;¾¥=ÆÄ~Qž‚!¢½nߦå—àµì¤šÄ[š&ŒIà—•gêLâ5ÒóÓŽÞȱ±ë!Àôñ;®Šß$ÁÖUxI´Eåweš1&ûv?Œ)ÇNIÌ?í褻LÍÊo¶MgŒ”Ù·;·J^£íXØk˜ ¢ö“=™¢·qʈ¢ß¬cŠ‹âw¶ÿoã!¶QÊU­\eš0¦”>9’¹#~GýiGo䨨õ`zŽø—^†,>ÂÌö\hL•iƘ0Ü'&öc˜àžbYF¯“fâz0A³òÛ ¿SΚüÊÜüоØÊ%¼èP¶[y1&Ú`L^œiû>æ5çÿL°Zùm;$ï«i¿ s9‰·4ͦ=¿YÒ{ÚsŠ`‚«œ»ŠÞȱ±ëÀÏ¿aUü¶e"ØÛãßI(º T¦cz×̾vFë\Šv½‘4c×C€©YùͶ{Ùvðûê¼qÝíÝZ×»dáWÞdL!$Û?r j þ˜VÅïœbÊ"Á/”„¿ÀT™¦ÓžÃçä7q§»€þ´£7rlìz0=Gü†EñÛÈ>3P£°±¨Ê­L3ÆDŸ ö÷Nå€~ÚÑI3v=˜š•ßÞêÍö³à³:•·îÊ…ÿÙ.¼œ†%c »S~¸dX.¶þ󮬊ßI('‚”BL•iƘÞÕÞoÆz· €ÚÑ96v=˜ž#~êø­ÙË£KSeš0¦œ?uL1Kî\â…KÑ®¢7’fìz05+¿‰gŸÞA7J‘œ1%…h¼)3¼» l0&oZm{×3øê%^Xîù-¼ožr±øU¦Ù$ýÕ˜ØÛ6´sìnä]Fo䨨õ`zŽø Ëâw´=5’F&*ÅïÒ4cL‘~OåÞƒ [Is+ÚeôFÒŒ]¦få7‘ÏfTJFZâ^SøŸßHïää•5/TÛ`LäcÅ ³?™¾Yù «•ßÊ!{×fmš2¦OK`ÑcÂ[Ñ.£7rlìz0ásÄo\¿#±¹çÌ\0¦Ê4aL~ãfL™zý˜ðR´«è¤»LÍÊoJ’Ùv.9:lžÊeý|:EÅMÆd«¾z´Ww~˜–^Ú®ÔÏ(9¥\´=©LSÆô™+®ïwrìžbYFo䨨õ`zŽø«•ß!F fÛ2*Nå*ÓŒ1¡~ê˜2té*箢7’fìz05+¿Ù{rØn*’d3+1‰ß´—ÄÞÂ,¯—{§rH¶£³½~³òWÅoÛ‡#ÇdŒ$—så*ÓtÚsÊÆô^[9v)ÚUôFŽ]¦çˆß¸\ùm;kõ7^l}/4¦Ò4aLƬïý´w«s*‡w9w½‘4c×C€©]ùí¥€9%#<–ò›WR’jÈÞ).¼ôØÍS9—™#KòîßÓB…¦eñ;ØïêÍkb9‰§4ÍS„ßiϹW.€·¢]Fo䨨õ`zŽøËmOl¯²}'Þ`ì/0U¦ c’,÷=&ÿ¢;×ðîeRFo$ÍØõ`jW~K´4·d'ôÆß›§r1¡Ÿ‹“z÷n“ÏÊ´]NDAûùoÓ²øÔÖ)ÿ)ÛžT¦cŠü©c2`ê±ò[Ñ.£7rlìz0=GüÆeñ;ùQ„½ü¡¿KÓŒ1Å|Ïüж\wV3ºí2z4×3€‰š•ß~ ê×iƒFÚ<•#—u5&Ð9l2&{2hÄq.»ÿ0ÑrÛ“HPSB.oT¦cÂxçj˜èîeRFo䨨õ `¢çˆß´*~úDS—D ˜ùU›&Œ)q¾÷ÿ¶äçΩ]Šv½‘4c×C€©YùlÇäu¡Þx“1QOôêL ˜i ˜^OI ĉá›mOhUü6 ¶ErÊ[¶Ö­L3Æ„ü[Çz,ÚÑ96v=˜ž#~Óråw&õÆ=>Ž£FX™&Œ)}Nåü²v'iîrî2z#iÆ®‡S³ò;eµ-•ªS—ùH€²µ®‘Î>þ)ä¼YÇdONÁ€‰2eþ*cZ¿³÷_{ á,nÔ¦c¢ôé`É¡»øñO;z#ÇÆ®‡ÓsÄoZ¿cV{áÕÏ ©4M“—)ߌ‰lÁï$Í¥hWÑI3v=˜š•ß¶3\azÕP¤-`²O’ì_Á>OÉon1&{2eã˜YR|˜VÅoLÑÞü èzÛßů2ÍîÊÞï¼Zƒ¶sìR´«è»LÏ¿iUü–ìÍ Sülû/0U¦ c"•ÆDÒëÇL—¢]Eo$ÍØõ`jV~ûÆ3°íBmCaŸ1ñëÆ2DÙ¼+çlËu­'ùfÛZ¿ÑÿëSH$ý=`©MÆ„¿såŒ=QOcºí2z#ÇÆ®‡ÓsÄoZ¿9{32Iè½ØþSeš0&{>uLÞW¶4|)ÚUô:i&®g7+¿ K |º9¢îvòæx@ìÛ‹MÉžly£K‘cüêø&^®üN¶Ï~‡%¤²ò»4M“_l¾þvrì.ç.£7rlìz0ñsÄo^îùm[¿]`+uL•iƘ$|ꘈ°ÓÁ’ïFÞeôFÒŒ]¦fåwößÁSRH›•ßà3+Å>OÆœ¶®¤ø““1×äÝu#Ë7ÛžðòÀK=bûʨœþñÖ¦cbú=• ÐјøžbYFo䨨õ`zŽøÍ«•ßö5 "xÿú²Ž©2Íæ{Jj´Õ¬S.ÀW9w½‘4c×C€©YùÁÛ‚°Ҹǘókò“¥øRÎ7SöQvÞ»Ò'…Ï!ñ_€i¹íINêµ¢ˆåúÚ4›]˜âÝó ð=Ì»•cw/“2z#ÇÆ®‡ÓsÄo^¿Ù^ÛvJââJJeš1&øÜcŠønÑJšKÑ®¢7’fìz05+¿3úY?«zó󸵕 ÿ³ý “ïã0¥([–¯'ŠG!êWi¹ò›‚ú·hoý_`ªLÆ1|fúÁc'Çîrî2z#ÇÆ®‡ÓsÄo^®üÆ$ ˜‘cyW®2ÍSHŸ~L(½Fq|—s—ÑI3v=˜š•ßÙþÿm+ÅÅVùMÉ@Íom‰Ñv“ø}gÈ4ÐW{~óªøíÛ‚O”4¼ý{Q¼6M§=Ó§Ž ¸7í™/E»ŠÞȱ±ë!Àôñ›—{~ e¢äsÛËI¼•i˜ìkýhLÞµ£4énä]F¯“fâz0¥fåwö’m?@Ð÷u·Æä[9zÕ¹³æ]‰I)#¦Œk_¦´,~‡¬ÆElq)ú1U¦ÙìB w­Än­\ºí2z#ÇÆ®gSzŽøVÅo¿”mÓÀd Ð_`ªLSÆtovJ½–éR´«è¤»LÍÊï,1@VT%ϧ»ýeL>NÀÖpðû¸Þ>f“1Eõ øU`Z¿í3È1P¤T#¨LÆøÓWìÃí°òt+ÚeôFŽ]¦çˆßiUü&Ì^ï9SYÇT™æŒéSùí:u'iè§½‘4c×C€©Yù½‚˜¼ï˜‹Ø[WR|¢oÇ¢ïŽysovDË"Ù@<§o¶=IËmORÌjLôcÊ¿ÀT™f]RU?ÝP§Sº{™”Ñ96v=˜ž#~§Uñmm'o°!\Ε«LÆäëô‡1qo®|ºí*z#iÆ®‡S³òÛ~cÃ!o¬kÿÚí. €~{?%[Â7'ñú¤+0 G/†újkÝ´<ð2{÷ñ–%Zʦé´gýtIÕÜÓ˜Ò=ŲŒÞȱ±ë!Àôñ;­ŠßI]Ãá”|¨d¡1•¦c¾g~EÄîjv)ÚUôFÒŒ]¦få·÷JÈ‘1+ÂfwD$à’F¸ôÕš`‡1Ù“bd{Õ¾Û(.­Šß¨†±¶Ã´ÿ‹Ê+)¥iƘB¼§¤z÷.ñ¦KÑ®¢7rlìz0=GüNËmO\í˶°ûDé‚1•¦ù©Ü/cJةʕ»—I½Nš‰ëÀ$ÍÊïl@°Í\Ñ»ý˜| A)‘ä-`z=Ù^.6[úå«WRdµí PFoÐH‰‹_ešuI%ýÌ.Ì©WÇ$W/“*z#ÇÆ®g“fƲƒeišÍ.Œ¿· ŒÛôrì.ç.£7rlìz0=GüΫ•ßœm³ Š¹¬ü®LS)ú1E•N¹@Î?í褻LÍÊoïA‰jÙˆ6ïÊ%Í~5‚ˆQ3nV~Û“ßõ•¾†¯nåV+¿s²ï-‘ .SišMâIú¹]à•^»Ê¹«è»LÏ¿órÏo¬/]¹˜’R™fŒ åsbb?ÝYÍônä]F¯“fâz0i³ò[)#°pä¶ÄocLÞ È˜7UØj{òz²QWÂëÛßoÖ1éòÀË@àÓ³àþ›c•i:»?ŒéÖʱ{Še½‘cc×3€IŸ#~ëòÀËȉÅÛ‚”§r¥iƘÞçoÆ”zâ·ÞS,Ë褻LÍÊoÅdœ…2IrÁhScßþ½ÚOËûHo‡1aJ>/3¤ˆQ¿y‰WWÅïL*”ƒŸ5¦¢Q\eš1¦w׊7c"éˆßz)ÚUôFŽ]¦çˆßºÜö$b¿sË™+`*L“Õ,j¼Çè‡û¤¹{™”ÑI3v=˜š•ß>â%åÀQ R7ïÊ%Ä„ªÞ"߸Ó&c²…?Ç€½)Ã75&]¿IÑ‹²b°½Ò_ÆT›¦Œ)üžÊaO.PþiGo䨨õ`zŽø­Ëâ·}Ó~á3»œQSiš¬fLŸ–¥s*§·¢]Fo$ÍØõ`jV~Û†@ÅÏÅ’ýêa“1QRJüÜ Ãî$^{r2Ö”sFcL߬cÒeñ;‘4å˶'¥iƘÂïìB֞Ƥ·¢]Fo䨨õ`zŽø­«â·mŽ2ÛVéu•ý/0U¦cÊü©c2ŽÓ[Í.E»ŠÞHš±ë!ÀÔ®üöNå•4qJ›•ßðšVĘ"É^k]²ØÛålˈ×W» èªø-¶IJ!ùv‰‹rÊ4›ö¬¿}åYz–ª?íè»LÏ¿uUüŽ) Jf°å½è.P™fŒÉ²æÃ˜B§S—¢]E¯’fæz0åú«{1& «oÅxo®œ¿~¢·K&Ú©üVµ¯Ïò•…1ÿïÀt}=ó“×hw¢À¤¹8•«LSÆ„ŸZ9¶=~'Ç®rî*z#ÇÆ®GS¿¯Ï{ž4ÙGY£m„€‹K¼•iƘ¢Ð½š…„íK¼9\Šv½‘4c×C€©YùÚ`¿¹„h;Pƒ‡N*µ’Æ Íö­B¶!ƒÍ:¦h›È^3V”9Ïžü/À´Üó;eûù7XXV¦)c‚ÏÉ/Kç€%‡»‘w½‘cc×C€é1â÷õyÏ“&“×&‡ š0¤Bc*M3Æ¿«YH¹·šÝŠv½‘4c×C€©Yùí{1Ðà=H|jÉ0ýßÿXl ¼ÿ´mädsJJôÊK(˜ÒWiYü`ŠjœWË+)•i’c¯á 7c‚NûænE»ŒÞȱ±ë!Àôñûú¼çI“}ˆd¦` °¦Ê4cLˆ¿ŒIR˜î^&eôFÒŒ]¦få·}ÌÑUžX6“7Rdàdo íjLþd Û¡ˆ1}˜–Ûžø´ôÄàÝ¥ŠS¹Ê4cL?,Èöø»{™”Ñ96v=˜#~_Ÿ÷BÒx~NbË—«Yeš2¦ðјl/Ñ[Í®^&UôFÒŒ]¦få·(Û.L•\Û&¨(pJ)úP‚½aï'³ÏúHÆ»ÂôÉÿLËmO|ª}Ⳋů4ÍÓ»[Ò›1…ÎÉow/“2z#ÇÆ®‡ÓcÄïëóž'¿í)h$ôɪ0•¦Éjftæž`¡¶a¿ûoÒÄðÓŽ^'ÍÄõ `ŠÍÊo¼±’ÿïcòòTïpÎ`£ ¯'{ÕÀÍ6Á_¦¸*~# Á³Ÿ1=¿*Ó¬Ž)æÏìBιØâ¥hWÑ96v=˜âsÄï¸\ù-~£*Ùû–®ÿhL…i²šù5Ûk5SÛJH˜îrî2z#iÆ®‡S³òÛwr† ¤¾¿®»m0&C%×— ‘ríÓûÉ>0ýºâ‹n} ˜Åïدþz—¢V®2ÍÿçT:/l+üÓŽÞȱ±ë!Àôñ;®ŠßIѯ¡Ë7Å=¦Ê4^ÍTß ´OÁÉ`ºí*z#iÆ®‡S³ò;¢&WúÐ~kN»ŒÉ¯ÿBµ”x£:ó͘”_} |:Ýk’Á×€iQüN™½o{Ò|u…ÿͱÚ4Ó˜ð·ƒèlåâ[Ñ®£7rlìz0=GüŽ«â·ßAóZ9ÎÆIþSeš1¦ø™Äkoeä0]Šv½‘4c×C€©Yù}¬¹í§BPÞÔ˜"%²Wƒz ªÖx=4"z|˜VÅoU´})EƒË"ÇjÓ$Çäs»Àá»L—¢]Eo䨨õ`zŽøWÅo!{ïýÐKcy©2M“ K7c²ÍzêÓ¥hWÑI3v=˜š•ß‘üÌÞÀ1Ón“×4«_ê!ŸYµÑþ¯'§h’Œ¬sHü`Zn{⢲‘ˬe£¸Ò4›]˜éÓ]À;Àt÷2)£7rlìz0=GüŽ«â· ï‘„™ ¸’R›Æ«™Ú¶å L>ªµ .E»Š^'ÍÄõ `‚få·÷ĵXžsxÝXÛaLÌ $†íF™òFÙ8¾Ÿl¯–¨}\9Ñ7 –+¿ò û+€²KjišžÊÅO?&RìÜåÜeôFŽ]Ï&xŽø Ë•ß~³Ê¾l¯@!LV¦ñj–½™ÛõwâÐ&øiGo$ÍØõ`jW~'Ûg ín1^1ü¦Ú4aL*x?eŠÚ9•ƒ»—I½‘4c×C€©]ù| ÎÞóM§¼¥h­k1ù ¿Wª[–ï'ÛÏy +MߦEñ;G¶P‘f…2Ç*Ólv!ë§òÛ>Üöì òÓŽÞȱ±ë!ÀôñVÛžXz¡½@dÌøoÒT¦ cJ Ó͘Œ0uNåàêeREo$ÍØõ`jW~{íD°G´ÁübHÑöÄoªmã¼f5m ¼|?™Ð¿Côù _¦Uñ;E/™ r .nT¦Ù$ÌúaL!tÊàR´«è»LÏ¿a½í‰Ú¶=F1f^hL•i˜$Á-¦dÐ9•ÃO/“"z4×3€ Û•ßF—²ØVNØb·\8xÿ)õÓqܽ+'^^)>R Ë¿L¸*~Ë«J¢ñÀòvAeš1&ÐÆúz\˜ðR´«è»žLøñWÅo~˜fÛqü&kÓ„1‘„›1‰v^Šv½‘4c×C€©]ùí—Aý/H¬’6ËØ›{Dbu*oΕ³'“±-6p"I߬cÂõ—äÍ‚A#S(€©4ÍäÏ©dé´ÖÁÏË"z#ÇÆ®‡ÓsÄo\­üû>H|ZlÔâ‚eeš0&ð¹òï÷@’Pç®^åÜUôFÒŒ]¦vå·@HL^åqó/º®æ3Â9ÐëJÊcò†ß†mÉ8ÓWiUüš_¢²÷Î+ÄïÊ4›Ä“ñ~ìç:­uí“ûiGo䨨õ`zŽøË•ß)«Ÿ!R)LV¦Ù©\Tù0&[²;Àt—s—ÑI3v=˜Ú•ß)EÌ–ë†^¸W.)ú..aP¿ë¾y*g?ƒ=Ùv„_-°ÄÕÊïàÝ_ Ì\´Ö©MÓI<ñwÄN¹^åÜUôFŽ]¦çˆß¸*~{iûÆüêý_©4MSé?uê˜ðR´«è¤»LíÊïDÂ>ÀOü÷*¿_Mc1)Ú_ìwÃ6ë˜È ÜÛx¯–ÿ&0-W~@Í®¹‘· *Ó¬çWúí.`ô©s*‡w9w½‘cc×C€é9â7®Šß~: 9¯ˆ,º T¦cú­ü~Ÿ‘7‰.E»Š^'ÍÄõ `¢Nå7©mAm-»åÞLØ^;œ…÷+¿¢&Èóšó&Z¿Yù%|ùî‚1U¦iÏ/Å›1…œ;=¿èR´«è»žLôñ›6Äo¥™S(NLjÓìT.çû 4’:ý*Ú£7’fìz0µ+¿¼ H3SÚÔ˜ 2‚³¦dAp·“=õ5Z6½Gm~ ˜VÛž7ñD¿sËÅ””Ú4cLïV'ï.©9v]½Lªè»LÏ¿iUüAèuÁª Ùµi˜\O¹“áR§]Šv½‘4c×C€©]ù)fßÐåy5Q1Œ€£íƒÚúí­86SNÞž.ŠAùïJÑýá¦Eñ;òÚ*`ôCµ"ÇJÓŒ1 üNâ^KâŸvôFŽ]¦çˆß´*~Ðû¶'E,€©2W3#Lr/Ðb/F§ò›.E»ŠÞHš±ë!ÀÔ®ü¶m\ €A‘òn£8°w^²Oâ`«íÉûɆlÙèÛÿ|˜–Ûž„äÇ“ARÈÅ]¹Ê4]ø[Ç :,éîeRFo䨨õ`zŽøM«â·-ÆÉ½+®OúK³KÓx5s±oÆtµtkSþiGo$ÍØõ`jW~«ñ<Töúl2&o>å³Å5eæi™x=™½‚Ù—Î!ñ_€iUü&òṳ̂É{™ÿ¦Ê4cLùz^Ã/z—xéR´«è»LÏ¿iUüfO~{ŒcA!~W¦ cbýŒñ^¸r?íèuÒL\Ï&nW~«Ï^²?"IØl{‚1©‘@žÓ-2–‰~ùY¿Y.À‹âw6"É»C%..Š×¦é$žß))>·¯ LÚÑ96v=˜ø9â7¯ŠßˆléïmØCq©6Mf¾» ¤ ¹L—¢]Eo$ÍØõ`jW~k "l°”R„醪`L( @)‹—ílµÖ}?QC¤WqÎ7iµò› ek)‚”§r¥iƘ(ýÎ.Tét૜»ŠÞȱ±ë!Àôñ›—{~£–)d)„ÉÊ4aL Ÿ«YÞµ£SÇÄw#ï2z#iÆ®‡S»òÛøŽmm%FI€›—x ˆý Œ!8omåÞOö“9oc•ô›SRxµò;{¹-»æ±¨ü®L3Æè—1qê1¦«œ»ŠÞȱ±ë!Àôñ›×{~Û._ê*‡T¦ cò;7cJØ»’ŸFÞEôFÒŒ]¦vå·m¦ý’¿õÕ¹d‡1ŸÆßñ›¼»§r¤A(CòM‰WÅo×` ÉR±•«M³¾òÞŒðfLÔÎòÓŽÞȱ±ë!Àôñ›WÅo̶,Cv)“ ©2Í}&¦$‚`ºí*z#iÆ®‡S»ò[²vñÒ†K[ÀdŒÉ÷bâ]yç´«1IFûYc\ÁÙÚ7iUüŽ‚ŽÑŒ!Åb®\ešÍ.´}ê‡1Å^_Šv½‘cc×C€é9â7/‹ß!‡øšbö®£ý/c*M3‰¯¡Ƙ$¥NËt+Úeô:i&®gSêT~{{»|~ðn“mà ¨ãp2LÞ­ü6ni?¦ÙÏ¿§ƒ£þ˜ÒòÀKöveÊ—¥i:»P?³ ÄÎí‚tO±,£7rlìz0¥çˆßiQü~yËZ%…rÿ_š&Œ‰¼¿äŘl9íX&øiGo$ÍØõ`êôüö‰p‘$pÞl­ èíºÅû)e¡-`z?Ù°Ðk˜4|u|SZn{òº¸/)r5í¹2Í“áÆõ0õZ뤻—I½‘cc×C€é9âwZ¿£mÔÈ¿JÁ˜*Ó„1åcâØeL—¢]Eo$ÍØõ`êõü–1e²]Ùî]9åd›ò‘š·Æ7½žœÈ6ƒô«åiYüæƒwè®îcÖ¦éìÂw}Ü‹1¥Ð[ünE»ŒÞȱ±ë!Àôñ;-÷üFŠ˜Š—•i¼šÙ‚ïã'W„zIs7ò.£7’fìz0uz~'eËô(¼5%Å» ¤(^lÀ²W.ðzrÎ"è7R˜¦çÿL«â7f´}©DŠö[¹Ò4cLáÓ]ÀoÝö¶r—¢]Eo䨨õ`zŽø–^²‚ÚÊ‚EÏïÚ4^ÍR–¬7cÂ@¹réžbYFo$ÍØõ`jW~' ê °„ùt·‚1ymfŒFÈBl‰ßï'Cbȶ±f˜^þ`Z¿Ñv–Þè(+Æ¢çweš2&¸ë˜|Úsoñ»í*z#ÇÆ®‡ÓsÄï´*~{Ëû8äWÏü¿§r¥i˜’í?nÆ4wê˜äR´«èuÒL\Ï&iW~ûÍ~è=¤h·Ž‰ÕÞœ)j¤­aï'Û2â|¢Ý?“,·=1WQïÑ•¸,°,M“iÏ9~>L[¬°Lr÷2)£7rlìz0ÉsÄoYn{b¯Ží»’w-†T¦ câ t3¦Ðíù-w/“2z#iÆ®‡S»òÛØNBïA™Œ½l“ŸÊÙ.,s¢dÿ‰[­u_OF[õY‚¯ß¿eYüïv .á„’•—¦É´g£ƒ÷}LãЩS’"·¢]Fo䨨õ`zŽø-«â7¼ÆB$Šþ=ÀTš&ŒÉïÙ^ïýX¯ò[.E»ŠÞHš±ë!ÀÔ®ü6<Ê”mSQv[ëŠOHI¯‘F|\c¢-‰ƒØ®\/ùæ•Y¿ÉÇäN§hŸÉ_`ªLÆäC)nÆ÷Ó¥hWÑ96v=˜ž#~˲øÍ"èÎÕ¨ä¿âwiš0&d¼‹J箜܊v½‘4c×C€©ÓóÑ{—Øv,l– }’/HQPyk|ÓëÉè}ˆÁç~„oŠß²:ðÒ6â™_J¹ 4MÒU­ê­œcêÓ5ŲŠÞȱ±ë!Àôñ[–+¿Ù¾ˆ³V)+¿KÓ„1…”ï÷€{#Âå.ç.£7’fìz0uz~‹KnÞAíŸ{Œ)c€¬lË7@‚ýI¼,¶ø¿Æ~|—1­Šß¯j.ñ[6R¼¬LÆäwmï.©ªØ“ .E»ŠÞȱ±ë!Àôñ[VÅo¿¶ Ù%ж§•i˜ì ÷jæKç(7_Šv½Nš‰ëÀ”;•ßÞí$‘*éÙ¼’_ÍÍÕ[½D¦­Öº¯'Û¦Zdެ߬üΫⷂ­,^›TŠ"ÞÊ4aLÎknÆ”°7ð"_Šv½‘cc×3€)?GüΫâ·-Q½p1©–mOKÓx5cŸYØŒ’:,ó¥hWÑI3v=˜:•ßèã“ü^³Èül¬(0H!yµLñ¡•»uL˜ŒZ0þê•”¼ÜöD³½óÁ&”/+Ó„1!~:¹cƒŽøï^&eôFŽ]¦çˆßyyॠqâ¬âÇ@©2W3–À÷‰ û¦½“4÷Ë2z#iÆ®‡S»ò›-ùŸ‚ñ–Ía>®JÉïÿÆ ¸ÛÉžØ>+‚x—â ˜Ö{~ÛÎT9$[¯Š¡ª•iÒWÞ\ïóO§LŸFÞEôFŽ]¦çˆßyUüFR/¨U£¸Â4aLÉï1]Œ)h¯ƒeN?í褻LíÊoÖ#0f±LÁ§¤d¯·= ÷+ÞdL^%öz ¡W ~˜V+¿ÅXƒRN¾·ü[.Pš&Œ)‹¼övrì*箢7rlìz0=GüÎË=¿Éˆ¿w<ï\ÿ÷T®4MÝ]6þïäcp:Is7ò.£7’fìz0µ+¿Ù6qö¡Ñ’ÝñMdnä09EØeL¶¥Îh«?äø]iYüÆW.ÛÇ\Ô1U¦ cÊô9ùõ©<=`ºí2z#ÇÆ®‡ÓsÄï¼*~ ùUÓl¯€·;ü»•+MÆDï7\¥l'^Šv½Nš‰ëÀ¤íÊoNY‚ý7‰Ê~%ÚÚMì ®SÜ’Â>콈*Á\vÿ`ÒUñ;ƒJ{é¹Ð˜*Ódv!Ðß}åz· ôR´«è»žLúñ[WÅo¶…]‚™‹ÊïÊ4cLü™+÷:$ï$Í¥hWÑI3v=˜Ú•ßÞ Ñ»¼¾`Ø9#M)&ÝîùÍ9Š-)FúÙÞýá¦Uñ½£V6yU·ý¹Ä[˜f³ Y?Óž¥LøÓŽÞȱ±ë!Àôñ[WÅoc°>/Öß—/+ÓŒ1iþeLÝëz)ÚUôFÒŒ]¦vå7+ÇDúžˆ·5WΓ&eì•·±ÜeLJQ%RVýf¥®V~c~µ‡ôÆyX6Š+MÆ"~&ñØß×ÙÊ)ÿ´£7rlìz0=GüÖå—~Lê-²0ÝjÓ„1qHô«1åNw½§X–ÑI3v=˜:•ßÁVwö>”Æ^w‡ïpî•íæö¶rï * >ÿ €ãW·r«â·_°Á`Œ:j,ÄïÊ4éù•cü0&xÿH+Ç.E»ŠÞȱ±ë!Àôñ[—+¿ôg÷c+|¡1U¦c¢ÏjFzâô.ç.£7’fìz0u*¿#Ù^Ìÿ‡ojLö‚ $ñNçóvËèS\>€_¦EñÛ+Ð}.±w䤲aištIõÓ€›1YRôäýiGo䨨õ`zŽø­«â7ˆ0ÇÈþ-——xKÓ„1à]•K:§r.E»Š^%ÍÌõ`Òú«{3&ÛÃù<\ÄÒæ©ºFh[ H¾#Þ®ü&b@~«å{Àt}=ó$Ë‚²\ 2MSHÆ$Ø– 4ܽLÊè»L#~_Ÿ÷bN Tìÿ+Ó„1qÆ{JнX=)Þ¼Ë褻LíÊoŸÐž¼Ærs|“Oª²K d¯í‰?™½*3„è}<¾Ø]àúzæ9&bPöÚÅáoIJmšM{6ê|3&ß}urìÓÈ»ˆÞȱ±ë!Àôñ;®V~sòYcà²ò»2M“AÇ­µ¢·Oì$ÍUÎ]Eo$ÍØõ`jW~0“<—kcÞdL¼­€#²®Ý~LäŨF›¼MŸü/À´Zùí½Ðþ” 1ÀT™&ŒÉòà3»0¥ÞV.^åÜUôFŽ]¦çˆßqUüfÍÁ»×{_Ü‚fW¦ c"¤»Æ•s˜.E»ŠÞHš±ë!ÀÔ®üF ¾ór¦°ÛÁ‚*Ù›â+uk+çOÎ9Å÷ª‚ú&0­Šß‰^s{sÔTñÖ¦I—TË„x3&K¸^Ž]Šv½‘cc×C€é9âw\¿½+u¶·Ž©ì`Y™fŒ)~bwÿŸÚÑI3v=˜Ú•ߘbò£5ÛÔò¼óvÑÁ2ÛïcÁÛDîV~c (ªÁhÓÂe˜¦Uñ[XrÀ×í¬†ª¦I_yùìRôñéí»í*z#ÇÆ®‡ÓsÄï¸(~ûÌvÛYC Ê)©•iƘ"ɇ1aìÐl?íèuÒL\Ï&hW~ÛþM5‹¼¤­­œ—"ù,^ïÚýß´¥1y£˜Ôðü‹ÀËmOü†’ý+äPX–¦Ù´gÒÏ©ÅéäØÝˤŒÞȱ±ëÀÏ¿aUü¶/ÚöH™"K©1U¦ c‚ß1fèsº:Is)ÚUôFÒŒ]¦vå7Ùï‹Þ×¹Þ.c Æ•¼Õ¦¼ÛÁòýY‰1.ýæVVÅ\ø*€©2ͦ=玙"‡c‚KÑ®¢7rlìz0=Gü†Uñ;‚}¿š8qQ`Y™&Œ ]6¼S~wNn% ý´£7’fìz0µ+¿Ñ…±€šÔ~ñÍ~L^ÆÉþéýœ^â÷Î\9ƒCJY¼•¿Ùöäúzæ9ö*õôÞµÿ.~µi˜ ì?³ _ãÓÛ9vO±,£7rlìz0=Gü†Eñ[Ô^žHö/HRôÊ©L3ÆD‰>Œ©wó[á­h×ÑI3v=˜Ú•ßÈœÀg7) n¼ãž¾óY¾øª5Ø™Äë÷PI½¦|³\VÅo ¶« ^†±lWš¦ÓžñwÚ³vz~)\Šv½‘cc×C€é9â7¬Šßðú>PT´*°,MÆï²cLI:ý˜òO;z#iÆ®‡S»òÛ6bŒ®‰­ímå VÄïá´¼Pm‡1"ECX€¾º•[¿½c»wY°M¹Ý*Ó„1Áý'ù´çÐeå—¢]Eo䨨õ`zŽø «•ßÞêÐËf”ðü¦Ê4aL?W³lïŒÖQ¼Ê¹«èuÒL\Ï&lW~CŠ1PŽb¼i®ôüeLjžÚ‹A}~‰½;“xÁ/Vá´ÉtùÀ„«â·ôߊ¢–¬¼2MST¼Y¹W·uZë`üiGo䨨õ `Âçˆß¸Üó›Rô¯~ù¡hW™Æ«ÚÆåØì­ê“x7ò.£7’fìz0µ+¿î„ˆÀD>xzSüÆì­„€ËvK†J™˜ýúýi¹çw²Á^yû« ˜Ä[™fÓžY>Óž™bG.À»‘w½‘cc×C€é9â7®Šß’Ô¾n!,V³Ú4^ÍPóGLAŽÚÙÊá¥hWÑI3v=˜Ú•ß‘˜Õ_û;vËD²—#yÛoÖÝ:¦Hd|ÍösÑ‹¿ LË•ß!ùhðúÅð˜*Ó¤çW¦ýd$îåØ]Î]Fo䨨õ`zŽø«•ß$Ù—t/·ÉÅ]¹Ê4cLò[ùÍ¡W`‰W9w½‘4c×C€©]ù£d5¬öÛ]i·Q\¤l;&#¼z\ï0¦è£ÕçQˆ¦ovÀEñÛËE ,A«K¼…iÒóËÐãs*sgD˜ýå?íè»LÏ¿qYüFI,ÊÖº¥i˜²|¿"Å^ÛS¼í2z#iÆ®‡S»òÛ¨ŽR¦H€wÿ¼õS9ï dsô+i«íÉëÉù%â¢7×ýf¹.W~ÍI¤’’j±•«LÆdÌæ& ÔÕ˜îrî2z#ÇÆ®‡ÓsÄo\¿Õÿ­¯ƒmá¿ÀT›&ŒÉ¾Ô{5Cì ¼T ?íèuÒL\Ï&jW~GN)¼Ð”wSBt¦åƒô’îjL‚Ú†DÐÖý&c¢Uñ;²óÛNI"wå*Ólv!¥û®)k/Ç.E»ŠÞȱ±ëÀDÏ¿iUü!èͤ(¨L³S9/æ¿5&è5Š#øiGo$ÍØõ`jW~}µCï~.›¤l¤Çè©mêvû1ù>Þ‡l‚ëSßìùM«â·fÛfïÇ’°`L•iÖW>SÏ)¥žÆD—¢]Eo䨨õ`zŽøM«âw ”ƒ¤à7Ú ñ»2Í4¦ÌáWcêÑlºí*z#iÆ®‡S»òÛêI}Lø¼ÁmÁ˜ỔdÜ¿_O¶=\ôŽØò7 ,iUüΆφ•~·(–•iÖWþn­ã {Œ‰ÚÑ96v=˜ž#~Óªøm[.ð¹Œjä¿`L•i¦1gºJì” Ð¥hWÑI3v=˜Ú•ß}*$¸ÛöcÔ Ñ7‚ñÝ„r‡1A4¾!Ù«ûUÆ´ZùMÉ ÄGŠ‘JÁ˜*Ó„1ÃÆÅ˜ràÞâw•sWÑ96v=˜ž#~ÓrÏo[{Ó­·Ã ,KÓLcÒk+çt÷ÿw#ï2z#iÆ®‡S§ò£Wo§(’ö®¤Ø'a`Í$×H¬­:& øUbÁ_ßD«â·}}ÀÉï —x+Ó„1ùØõ›1î°Ð¥hWÑ96v=˜ž#~Ójå7„¨h >í/0U¦ c’ðÛÁÞ…ý¤á«œ»Š^'ÍÄõ `â^å7ª7¶Ç)Ná¡`LàS‡%xqf¦Ý–ÀH“ß{Ö„ßì`É«â7ysSWãCQù]™¦ÓG°órÈ0ñ¥hWÑ96v=˜ø9â7/W~Cõï„Ê£ÜÚ4cLô¹Ç„ÞL¨“4w9w½‘4c×C€©Sù-1ˆ*¦zI×c2X7ÆÉIØve»$?#ˆ@YjÎÿ˜–ÅoÌ>A—½ƒyŘ Óä>¦­N÷É/ù™NŽÝŠv½‘cc×C€é9â7¯Šß`œß …«c÷ß:¦Ò4aL)§_ÆÔÙÊñ¥hWÑI3v=˜Ú•ß>ÎýNH6ª·Ù]Ñ6­ê*¬ ãî$^´oÀˆê3é¾Y.À«/mkí»3”V(XJÓ„1Ùco”'†ÞzæŸvôFŽ]¦çˆß¼.~Côº²à×÷Kñ»0M“¡Æ}é¥ u’æ£hÑI3v=˜Ú•ß“S2„FH›wåÐÇ:ú\J¶Û­ü¶ã«ãxæ›È¦åžßÁ'x"Ù¾6ý˜*ÓDcòê©›1±Ro+w7ò.£7rlìz0=GüæUñÛ6IÉ˪‘°\Í*Ó„1‘ü2¦€½¾í*z#iÆ®‡S»òÛÖß,Ùo½eå-`z}’à¸ìó4€Úï`™ííõÞºø+úuø_€iUüNöÅ壭\ThL•iR+§ð¹xHdÞɱKÑ®¢7rlìz0=GüæUñ›($#ýQ±è`Y™&Œ‰Tï%:«Yºí*z4×3€)µ+¿íµÉ˜m·á¿ý®ÆäC„¼Ó¹I²Ýó›âkdqˆ‰Â7·ri½í õ³ÞÞþ¢SešN{Ž÷}L[§¤#¤O/“"z#ÇÆ®gSzŽøVÅoˆcüÊÁ•ÀT™fŒ)!|Sìu°L—¢]Eo$ÍØõ`êôü–èWCbâ¼ÙZmˆ ¾· Ý:&òª/{¿m7ùÍîiUüönµQØëØC9ð¢4ͦ=‡ðaLÜ[ü𧽑cc×C€é9âwZîùÔò?f¤XTåÖ¦cJáSÇbïJJºy—ÑI3v=˜Ú•ßlxd|)d‡ùØÉ²òÛEÞœ 9o]â}=ì3óƒÑ9Wû`Z¿½=yï@/H/X Ó„1 ÇÏ©$î1&þiGo䨨õ`zŽøVÅoð›œþ‡²µniš0&K”ûø |¤I'i.E»ŠÞHš±ë!ÀÔ®üN™S6hQ»#ÂÅ%"d`2ò´µ•{=Ù5*Û•¼zÍ}˜VÅoöÃx (!ê_`ªMÆ”«Um×{Àt)ÚUôFŽ]¦çˆßiYü§¯ÆcCÁ˜*Ó„1y ýk5ÑÞ\¹t+ÚeôFÒŒ]¦vå·D/ûDÌ»wå@¼:Rm‹ðjM°Ã˜$2¢·ý´0óù,ÿLËmO‚íLŒ0T“x+ÓŒ1ÌÆ{uLéîeRFo䨨õ`zŽøVÅïÀ>æV¼®¬¤Ù•iƘÞ÷˜¼î¨Lr)ÚUô:i&®g“´+¿ S(G§MœãfSôq‘)†äåß›ŒÉÏ–Ôǃ»PüM`’å—ÙÒ!cð“ÕràeišiLðì:À$÷Ë2z#ÇÆ®g“_Šv½Nš‰ëÀ”Û•ßöÚ&ãx~·$ìv°ô¹Ã¾“3`ò›);/_ONmSâÜä›À”WÅo¿‹¦~J‹ÊïÊ4aL~5ù®•Ó˜:­uò¥hWÑ96v=˜òsÄï¼*~S`J„^/\Ì•¯M3Æ„¿uL¶\÷€éR´«è¤»LíÊo•ÈÞÝ6ûD¼­áÿ÷¿ìGrÈ`@/úº¸3‰WSVûü}õO_m—WÅo׿}‚½nÑZ·2MüŽœyuºê䨥hWÑ96v=˜ž#~çuñÛV‰@À>½½¿ Ó”1IúcêÐìüQ´‹è¤»LíÊoûÈ É~y±?d1 úVÌÞ“”®…-Æ”Cöž”5¤o6ŠË«â·í“ld4.3å•i˜|Å»“t®=åKÑ®¢7rlìz0=GüΫâwò‰ZÁþ‹a„•i˜\æ½ôV³ôÓŽÞHš±ë!ÀÔ®üVÆP‚°9%%1ùTôX1¾z½m1&ò«®Ê¯}É7¯¤äUñÛÉcªœ°V›&ŒÉ‘ãfLI S./E»ŠÞȱ±ë!Àôñ;¯Šß1úèm¥¶Æÿ¦Ê4cLñs ¹·š]Šv½‘4c×C€©]ùm*ÛDð;)as®œaRL˜(r†÷E»-Æ”8û LEg\ߦEñÛ§ 'Û[ÚW˜‹îµi˜Œˆß· 0I¯aÖŸvôFŽ]¦çˆßy¹í ³ ö¥Ø_hL¥i˜8}ªrbìÔ˜èÝˤŒ^'ÍÄõ `Òvå÷«¸!¾öq€›§rœ£ÿlòM¬mŠw“߆Qû¯½m_x©Ëâ·mMë&f,5¦Ê4cLô9ht`êÜÇÔ[Ñ.£7rlìz0ésÄo]¿…|d¬­Î‹­\eš0&¦,7cŠÚ»Ä«·¢]Fo$ÍØõ`jW~»p ž‘D÷F„‡ÿ12ûìE1»Œ ‚’ý°ƒâ7OåtUüæà£¬0 E£¸Ê4aLÒçTŽ}bJ;Ç.E»ŠÞȱ±ë!Àôñ[—^JÆFЫ«‹+)•iƘè3WÞÇttê˜ôžbYFo$ÍØõ`êT~Çè–ìÝKÒV¹€&bãˆÕ/п.Úm1¦sF ¶N`þ橜.÷üNd;ûŒA¨lß\™¦Óž»¤2õšêÝÈ»ŒÞȱ±ë!Àôñ[WÅoËþ¤d/¾½E¹@eš0&ÌŸÕ õ¦¤è¥hWÑI3v=˜:•ßRô‹9™pOüv%BLˆâ+økÊ÷cŠB>ŠÙ^0úê”]¿ÑEìµ—äwdþ0¦Ê4cLöç}ÇN“^Šv½‘cc×C€é9â·.¼„$ ¶ïwÿ©4MÊoåwÀÞ\9½§X–ÑI3v=˜Ú•ßYM‘¼ÉvKƒøèFjo‹l2¦ì/-„mN’|˜V+¿½ÿ¹S8/“-:XV¦Ù´çû¯7&ÄÜÓ1¯rî*z#ÇÆ®‡ÓsÄo]¿%[§Ä¹ß\™fŒ‰ùsW.ØÔJšhÿýiG/“fêz0ù/ÙdLYSÂÈ,Áw›ý˜’­ß¯Q¼ˆ¶€éõd‡%ôÛvñ‹wåî¯g!dzwûËT `ªL“û˜YäØ(j“•Ûoö«hÿÞȱ±ë Àä¿äC€éþ¼çI“™-•8G„¢ƒeeš0&`¹STl‹ßö›ÝS,Ë褻LíÊoΙH"§½r‡u ˆ2IÊ»uLÙ‡>©}äµ ß¦UñÛï{(¸"_Ö1•¦Ù´gúí+ï3A;9v)ÚUôFŽ]¦§ˆß÷ç=O?˜fÎÞùÊî•i˜â]•kËvw5»y—ÑI3v=˜Ú•ß™ØöÞ)$Úº’ⰮƷ¼w JÞ»’òzrÛú<â÷Nåî¯gžcb›mo“§r•i6íhhñÚov•sWÑ96v=˜ž"~ߟ÷˿ӪøÍ¶«Í)Ç ewÒ4ö>Œ)³ì䨥hWÑ96v=˜ž"~ߟ÷¶'ñØov7ò.£7rlìz0=GüŽ«â÷«‚#úëŠî•i¼šEåxwˆ‰¹Lp)ÚUô:i&®g´+¿@"»r9ojL@ ~%‰è~wƒDû¸Œ]ªÛ÷ÅÝ_Ï<Ç|„ ¨ý#c±•«LÆ)}4&oÑÕɱ{Še½‘cc×3€ ž#~êømë„&Ÿä+Æ_`ªLÆ”õSIèÝ;[9¸í*z#iÆ®‡S»òüFÒ(Ñöµ»wå8röâ-ÛÂVkÝד1G¤ì=W¾Øóûþzæ9&¶érúÞ³?ÿSeš0&{ÂgÚsê^IKÑ®¢7rlìz0=Gü†Uñ›5Gµ·ÈõÖâoeš2&Í¿ŒI;û¸í*z#iÆ®‡S»ò¼ÄÒIÛ…nV~c–H.o’¿Û]"Ž£Kç¿Yù «âwõîMÑX,~µi¢cfN÷í㕽kOp)ÚUôFŽ]¦çˆß°*~ƒ÷þ!ˆ8SešiL)þjLÜž’b¿Ù¥hWÑI3v=˜Ú•ßÞo›3á«|óTŽH0Ú‚íÆ`Kü~=Ùv#öQ!»ø*cZ¿Ý’ý>‹¹r•i6‰äwOj÷c²ßìV´Ëè»LÏ¿a¹ç7dQŸªâí¥ ©4ÍýÞ•³-{1ݼË褻LíÊo`ïí“0$¯DÜìÇäRŠø½R£[yw®°ó¬,I½ã7iUüv)Þöùö?¡ì`Y™¦“xô£1¦f3BûÍ.E»ŠÞȱ±ë!ÀôñVÅï”ü‚%Åø¦Ê4cL¿§ÓL½Õ ÃO;z4×3€ Û•ßjô¥¬ÓúëBc²ÝcJÑ{œ‡mÆX¼Aˆ¼þ"0á²ø¼ÞgR•[¹Ò4aLÞ7áÓW^Û­uí7»í2z#ÇÆ®g>GüÆUñÕR?ÀŠñ͵iƘÿ2&@øiGo$ÍØõ`jW~Û/+^$y©=)¾†#Að»´{W¼ß'Ÿ1}óT—ÛžH&Û•úÜÒ¢µNmšõ•WþÔ1c§\ï^&eôFŽ]¦çˆß¸(~K6n¬¶Ä¢Ú‹ÿ7i*ÓŒ1ý¶jŒ.¾v’†~ÚÑI3v=˜Ú•ßà×QÔ²]Pw+¿Ñ ™ –@9½ ·SÎÁEÜäçK_¦eñÛVÛøAD.†ªÖ¦c¢œS»Kªýf·¢]Fo䨨õ`zŽøË•ß¾&ûòÊi˜rú=•cáŽÆ„w9w½‘4c×C€©Sùƒƒi0ˆáùÙXÁ˜4%o<$CÜk{âO)gò’‘4oêû/À´<ðÒ›úË_´o®MÆ”âçvøÙɱ{Še½‘cc×C€é9â7®Šß¯2@{lóUŠß•iVÇ„Ÿî‚Ñqoÿ)ÚUôFÒŒ]¦Nå·Ïu!cL‘d¯QÜÿý‰ ‰øBÚ®üö +Æ´0ÅüŹr÷׳cö90'¾ ³2ÍSøt°ðŽ©½ÅïžbYFo䨨õ`zŽøË/%8I¤Õ\¹Â4aL’"ߌ‰r¯Æ„î)–eô:i&®gµ+¿ lgÔG NqsJŠß3Æ$1اH[[¹×“ƒ}TbAï»òE`¢Uñ;‹¿÷^lúVÿ\I)L3Æ~Oå€S瀅âO;z#ÇÆ®g=Gü¦å¶'*ÙvÖ)A¤¢À²2M“÷%½“½–t÷2)£7’fìz0µ+¿)QNöû…µ°9WÎå 9+‡We'•šŒ‰RˆªŒ‘íÕý*0­ŠßÉ/Ù”b ESešÍ.d†c ½t)ÚUôFŽ]¦çˆß´Zù ˜) ¸öW\¨M3Æ9~ÇÎþŸ®rî*z#iÆ®‡S»ò›1çh;*à¼É˜l7–rò³5°ýRܦד)½ÖÖo¶=¡å—¼ ›$F-·r¥i:í9~Nå¢öJRèžbYFo䨨õ`zŽøMË=¿`R{‰R.’¦2MSâß:&Ì]Æt7ò.£7’fìz0µ+¿¶p2¢g¤Gh«ÀòÝ7‚—"¡ÅÙeL¬)±„œ¢Æ¯6Š£åÊïLFᑽ¢½^šfŒ ùÎ1ð»J»Ë¹Ëè»LÏ¿iQüör×èÓ}NPA³+Ó„1ÙænÆäSº:I“ÚÑI3v=˜z=¿_-SfÜíùíÈ>Jȇo2¦d,-$RòÆß߬ü¦Uñ;úwýÄ‹K¹ 2ÍæÏ©œíñ;•ßt)ÚUôFŽ]¦çˆß´*~û”…0H„"i*Ó„1ñïÌ//ãé_Šv½Nš‰ëÀÄíÊoAò=€¨ÌÇNþeLàC¾½!“7ɲɘÄë§ì߃È75&^¿1y×;µ¿G‹"ÞÚ4cL"¿S·Q_Šv½‘cc×3€‰Ÿ#~óªøMÎBr’軆b+Wš&Œ‰ïÛˆ¤ÎVŽ/E»ŠÞHš±ë!ÀÔ®ü¶_]hc°ÙÖ•ŸiŒ"|6_|÷åÝaL¶‹ó’D³ƒ%¯W~Û‰>³¨ü.LÆD"¿Œ zSRøSÎ]Do䨨õ`zŽøÍ«âwˆÞÁ¶¹¨cªLÆd»‡_ÆDÚFÀ—¢]Eo$ÍØõ`jW~‹mÇlï™bðv-›ŒÉ¯ÉEf¿óK ÚbL9{¹ ï%˜V+¿5Æ$ ÈÇ,+Ó„1‘þv°ŒÔÓ˜ø*箢7rlìz0=Güæå¶'™rÂÀ¶¼–#Â+Ó„1Qüœ˜ÄØßÄw/“2z#iÆ®‡S»òÛÛêñIó‘cR£LªÆDËôì0¦Lb{Èä»–¼*~x¥‡Á´•ú L•iƘTàØ{¬üR´«è»LÏ¿y¹çwʶIBÈZu¨LÆôŸ=‹marG˜ä»‘w½‘4c×C€©]ùÁïàfµß~³µ®÷i„,•!Ø.vKü~é¸)qLñÕ†ö›Ýx¹í ³ýRÀl|¤(°¬LÆ„ú9h„À½I¼|÷2)£7rlìz0=Güæåžß!£‘Wô¢ê¢»@eš2¦ ¿Œ)u*¿ÓÝÈ»Œ^'ÍÄõ `JíÊï’ø}uˆ²y*‡./ óºM¿Å˜‚‘´ .Teýæ$Þ´\ùm8™³&öŒ¿ÀT™&Œ £|tLÍ©Lé.ç.£7rlìz0¥çˆßiUüñ؈ BÅ•”Ê4cL”>•ßÞZ¶“4ðÓŽÞHš±ë!ÀÔ®üÎT8:xûíîè×JÔdžò®ÆäÝôBôC&Û~“1¥UñÛ–òù&Ó©¸Ä[™fŒ)ÆûÃŒöõ¿KÑ®¢7rlìz0=GüN«â7f À><@¸ì.Pš&Œ 2~æÊ…ÔÛÊ¥KÑ®¢7’fìz0µ+¿3[‚e[‰£L›”ý˜Ø§£PH‰(ìV~gÛ”Tsšsµ¦å—¶¯E—Ü|r[Á˜JÓŒ1…ßÛ%’”tO±,£7rlìz0=GüN«â7§—6dëk¢b+W™&Œ ~;¢yoßÎu”~ÚÑI3v=˜Ú•ß91cô©—‘wïÊ¡±%{…ü¶;îV~gVIÂÙ–{×¾ L=¿)Foƒž©^š&Œ ’|rL±»øý6òþ½‘cc×C€é9âwZ¿5°ÚŠžÕ'#ÿ]ÍjÓŒ1ÁU6ãŒ)v“æ­h×ÑI3v=˜Ú•ßÙ¶cèC§ƒßÜ<•3žÅÄIÅ^—m)'}µ"þj¹@Zn{¢ šRö Übñ«LÆd«ßGÇÌï+Ý­»{™”Ñ96v=˜ž#~§Uñ!¢àk¶F±•+M3Æé—1éԘȥhWÑ뤙¸žLÒ®üÖà}$ÙÇœÐ\é)ê˜4&UÛYx™DÞÕ˜lÛë³ m'Dß¼Ä+«â·(St¤5¾SŒ¯LÆ)|N~]Æë䨥hWÑ96v=˜ä9â·,‹ßÄ`/¼ª3âwiš0&5q­f*ñÝž¢‘4·¢]Fo$ÍØõ`jW~kfÃi1”ˆ0?+ë˜|1D±ÍXÜ=•SQ/VHˆ$é›WRdYüN~v¼Û_y‰·2M“¦_ÆÔ»+'·¢]Fo䨨õ`zŽø-Ëâ7FŸ×FÞX¬(°¬LÆd;ô{ç ^«Ö¦[Ñ.£7’fìz05+¿!ض@‚ñá»̆Æä55†Ã˜â»sÉc²'¿Åkÿ ¿Y`)«â73&PŸTv(M3Æé3íÙþº0]Šv½‘cc×C€é9â·¬ŠßÙû°[ús¬€©2MSÈp3¦¬üžòØHšKÑ®¢7’fìz05+¿!¸Èƒ9{³òÝ:&¿ÒrRï@µÅ˜ìÉ!sò!ãöº}³í‰¬ŠßÁ {ËšË:¦Ê4aLF@?:¦Lu€éR´«è»LÏ¿e¹òØ»°½¦ ý=•+MSÆô¹+gŒ)Æ0ÝåÜeôFÒŒ]¦vå·Z‚«7?¸ß®üNíNÀ»Ý|š(æ„_¦ÕÊoYÌ’É8o1í¹6Í&ñúÄ¡S+'W9w½‘cc×C€é9â·,W~g Ìðº1ZhL•i¦1…|OIQÛÉi˜ò]Î]F¯“fâz0åfå7ø(WÅÀRw§¤DŒH쥸×öäŘˆY@2£À´¯Á?S^¿9Ø[o”7’p¹•+M³I<ŸZ9ÛåvJRrüiGo䨨õ `ÊÏ¿óòÀË”ƒ½î웯¿4»6MV3{è½gÉ =ñ;ßS,Ë褻LÍÊo §Û￵•sÆ$’Å/EçW—ÆM‰½@Þdz0}ScÊ«â·oKý½'ŒeÛ“Ê4›ÄxÓÏÈÔ+IÉøÓŽÞȱ±ë!Àôñ;¯ŠßɸMжñHEÛ“Ê4Ó˜’Ü“x}æb˜.E»ŠÞHš±ë!ÀÔ¬ü6Æ$¶¼ö*ÀÝžß Y(ùûaܦד}æ%'eÛE~³Ž)/‹ßšÔö³¶3-O~kÓ¬¯<‡ÆD™;uLùV´Ëè»LÏ¿óòÀK¤ˆS¦$eSiš1¦D÷˜%½ûæ4’æžbYFo$ÍØõ`jV~oÉs6æâ³xw&B2\K ºÏ˜ÀÞX°•!ÂW'ñæå¶'è÷÷\ŠÏå´çÊ4›Ä?ý˜"uÇ7å»—I½‘cc×C€é9âw^¿ýÚ¾pN¬å©\eš1&æû“׆0ÝŠv½‘4c×C€©Yùm¸` 0+HpÕb÷T.©"/ÏŒ[–¯'#½› ˆ|UüΫâ7ø8± ÁŠËÊ4ë+Ïøé.@!ô€éR´«è»LÏ¿óòÀKò9C^ÁÈe£¸Ê4cLò)qζìtÊôžbYF¯“fâz0i³òBðϼ2h³ç7F ¶•[Æe«QÜëÉ`\+û=|ào¶=ÑUñÞ}X Ùn©èù]™f}åsø0&ƒÞNw½í*z#ÇÆ®g“>GüÖå—ÙKª½ [Ñ] 2Í“†»*7+sg+§÷Ë2z#iÆ®‡S§ò[Ôð4(“o«6“íÂ"Ë벜&Ø®üö!á9y7ÆoÓrå·mÀªím¥lW™f=¿T?§r"`ºË¹Ëè»LÏ¿u¹ò›³¦€œ,ÏŠ–•iʘ>’†±î” è]Î]Fo$ÍØõ`êT~Ûê+Þ¬E‡]É‹jÀ0 ÅK,·+¿“0 dû?¾yWN—ÅoŸËœ•0åT0¦Ê4cLáS{aŒ²W`©·¢]Fo䨨õ`zŽø­ËmO‚mÛE’B(;XV¦é©œò͘$½/¶7’æîeRFo$ÍØõ`êT~k¢H‚¶õдÙ]“‹ɶ-Œ¶Oå4¼æƒÁbú橜®ŠßͳDÌ ‹S¹Ê4cLé£cz›N¥^Šv½‘cc×C€é9â·®ŠßIÈ'$2AY.Pš¦§rŸ™_YzÓ¥hWÑI3v=˜š•ßàs—Œî(×ËS º`L¯á*†J^ë®[—xýÉ!Ç(Y4ùÈ«oÓòÀK!6¨õÛØ¡ *Ólír?]R5wÊôžbYFo䨨õ`zŽø­‹â·x[1ã"â×>ÿXÖ¦c"þ0&oíÞ¦ÂO;z•43×#€)Ö_Ý‹1ù„oÛ‚Fƒ¦[[9cLÞ|:%âœ7çʽôÛà™†jßlw}=óó–TÉKëB€¢çWmš1¦üÛó ¼_ ˜bˆ?íè»L1ï…¤A_# Ú_0¦Ê4^Í4ÃG¨Íá}šÔ¦»œ»ŒÞHš±ë!ÀÔ®üF cD¿yœ§tÁ˜r6Ê!ªOÙ=•C4fÉF2í¾9%åúzæ9&â/{Ψȥø]™¦³ ?:¦WiµgÆpO±,£7rlìz0=Fü¾>ïyÒxY²1‘2‰Se¯fšâLÿ÷?'9í:&ãU?í褻LíÊoËo2Öòºï–w» øoC)·;Xzƒc%(ìCe¾L«âwB¿¿GI˜Ë—•iʘàWc²ÍW˜.E»ŠÞȱ±ë!Àôñûú¼çI“ÑÖŸóÕ^ü‚1•¦ c"H÷êþÚxu€é.ç.£7’fìz0µ+¿1‘pûÍóV¥kL¶öÉpd¤'nµ=ñ'³ÄÈêHžâO宯gžc¶š€úÌòÀÅ””Ê4cL†÷Æa1\Šv½‘cc×C€é1â÷õyÏ“&ƒ’d[_£WˆüeL¥i˜AnÆDÚ¿mÿÓŽÞHš±ë!ÀÔ®ü¶\ Ks•€ÛuL‰½ %F"”¸Û]UÀ;€— |±Àòúzæ9fä}>žúàÒrJJiš1&†_)JûT.†«œ»ŠÞȱ±ë!Àôñûú¼çI“½ú(‹*ù ²âĤ4W³œÜ/‘¼V³&0ÅÏË"z4×3€)¶+¿IÆ”1!#ïV~ Ú.. ÷Uíî”sÈôR`€¾X`y}= 9f8™}Äùbñ+M3Æäsr>ŒI:[¹x)ÚUôFŽ]Ϧøñ;.ŠßbË„mlÏAå•”Ú4^Íò«.û͘ì}ŠíÖº1ÂO;z#iÆ®‡S³òìƒS£MQ·ïÊ)!ǃˆ[#ÂýÉÉöÑÄ> %Í/Ãü 0-Šß9¸|ãPmX]°T¦ cbÈ¿•ߢ=`ŸvôFŽ]¦çˆßqUü6B”©HšÊ4^Í$ÝzH‚ø.¶l$Í¥hWÑI3v=˜Ú•ß9úü L»“xÕ»3zg– »•ß^—¾Ð{¤‡¯2¦eñ;¾6~®ž“ÿ¿KÓ¬ò;~æ+ØÏäö•”oE»ŒÞȱ±ë!Àôñ;®Šß£×âÙT´=©LãÕLü–í͘ÂUtÜHšKÑ®¢7’fìz0µ+¿'/´á$JqWcÈö¦DEïÇ´yWl³ÔÈ…Áù75¦¸*~ƒý.ä£ò$”=¿+Ó\cÒ_éµLµ€I~ÚÑ96v=˜ž#~Çå—(œB¶¥ù=×ô¿/KÓ„11㽺'C’cº§X–ÑI3v=˜Ú•ßüº³a»Ûì÷Þ¶ïÊØWHÙï”îV~“Brv©~•û«À´ÜóÛëLmße´·ØÊÕ¦ cBüT@ø/ÐcLw#ï2z#ÇÆ®‡ÓsÄï¸(~k”ˆ¢àÇ¥ôW˜¬MÆdnéfL¶nw€ ÞŠv½Nš‰ëÀíÊoÌ„®/E¦0?´/» hJâW•Pv§¤”½ ~±ç÷õõÌsL¢­)Iˆ’QÞ¿‹_mšM{¦_É>Þc‚«—I½‘cc×3€ ž#~Ãjå·m¿¢ßðé­ESešœÊE‚û)ù%’0]åÜUôFÒŒ]¦Nå7š‘lS†´[ÇdŸ¤Ø+ú¤¸u%ÅŸý²³7'ˆ_Fp}=óB°­­!¥Ø¯V0¦Ò4›Ä“?s匋vÚ7G¸y—Ñ96v=˜ž#~êøÍÞ;+{‡ê¢\ 2ÍN嵺cJD:&¸í*z#iÆ®‡S§ò;ˆÏBŸ¾LÞÁ’íãSE¶WeûT|R&y÷Pøfå7¬Šßjô‘³¸è ©2Í&ñЧò[9öä¸í*z#ÇÆ®‡ÓsÄoX®üÎŒ¶òtåï/0U¦ c ï –oÆD¡#~Ã]Î]Fo$ÍØõ`êU~Ûo-’)KÞ¾+÷:Ò«Þwçʲ}ZI³½eÆ)¾ LË•ßÄÝÁgü¦Ê4cLîv1&ïqá»Ë¹Ëè»LÏ¿aµò;&/•ñƒx¡²%EišhL*üaL¶YïÓUÎ]Eo$ÍØõ`êT~ۖʈKRòž­»Œ‰r²¿Õ -7/ñú“}n“HD¾y‰–Ûž$2DqÙìݨäOަ9cúÌ.¤îµ'¸{™”Ñ96v=˜ž#~Ãrå·`LFþí’BcªL³S¹D÷Ѷwhw°Œx—s—Ñ뤙¸žLØ®üö–º9IB/±Ü+gQmûš4¨¦¼µ•ó'ÛÏ2Ûºc ßÔ˜pUüöIV9DÔ¬E3ÂÚ4cLésWN C:^Šv½‘cc×3€ Ÿ#~ãªøíÇœ0%eÏïÊ4«cÂ/ÆÄöFuº ü´£7’fìz0µ+¿}þ®í¥ü‚ïÞ•5ˆ§}SâÝS9¶]$Ùë…>¿á«À´ZùmÙHFѥ墈·2ÍÂÝóKQ©³•뜻ŠÞȱ±ë!Àôñ—ÛžDû‚_'^ZNâ­LÆÓgÔß“ƒIs÷2)£7’fìz0µ+¿“º„"«<ÙÕ˜BàíMö1ìjL†âöMøøFïQ÷M`Z¿s^ i "R]{*L3ÆÄ=_™±#~#ÿ´£7rlìz0=GüÆõ¶'’³½C>è¶¿KÓx5K¯¦$c2‚Ó¦O/“"z#iÆ®‡S»ò[$ÊK}yKüvIÁÍO°ÿÙíÇ$†J¬IÀ/ʳí .÷üNÁû½ú¸ÀT™¦}NåH¨Ó%ïFÞeôFŽ]¦çˆß¸,~«e²ú­¬¿4»4W3/O»Ww&èLâx+ÚeôFÒŒ]¦våw&ÉÞ©ÜÇt·»`d˜¢mÉh÷®\F!Ÿ¢>ô›•߸Zù1D¬AŠrÊ4cLø¹ec«TîÔÊáUÎ]Eo䨨õ`zŽø«â·Á Û+8&)çÊ•¦ cJø©cbÄÔ¡Ù~ÚÑ뤙¸žLÔ®üÎ P…ÃB™cYùm0œ)0FÚÕ˜Dä5!%{_תּ߬öqx¼½þÅ•”Ê4ë+/ù>•ó.`¢KÑ®¢7rlìz0ÑsÄoZ¿mqLA‰¸œ`Q™&Œ)ѧŽÉ€I:§rt)ÚUôFÒŒ]¦vå·O‚5fá½­œß• ˆÄJ1ì3¦ä ¢m~-Î7Ëh¹ç·aXò~š¶±-ë˜JÓtχ1e1ÜïäØÝÈ»ŒÞȱ±ë!Àôñ›VÅo¯á É ÂB˜¬MÆd;¹p3&C’^Ò\Šv½‘4c×C€©]ù½ ^WqÚµŒ‰Ð5XcIÞ³úvSN¨¾ £Lç³ü 0-W~ƒ­S.FÕ¿,jÓŒ1ÞS&íU~Ó]Î]Fo䨨õ`zŽøM«â·Ÿg'rIBÊžß•i˜0Ñ}WÎVúÞ‰ ]Šv½‘4c×C€©]ù­ª>I„i·Ž)½t`eø&cÒœ!eïnàåߦUñ[ýŒñÕÉS¹h­[™fŒ ?÷’½ £S`I—¢]Eo䨨õ`zŽøMËâ·—ÊØâµl­[š&ŒÉg³\ŒÉEÛŽøM·¢]Fo$ÍØõ`jV~c´·&d6Tœê.“w9Øï³èæ]9ôÚVÛHK`ºŽF¿L«â7Û._SâÌJÅ%ÞÊ4]x• øìÂëT¡‘c—¢]Eo䨨õ`zŽøMËâw –þÀsqbR›Æ«kÌwå7 ö®¤ð­h—Ñ뤙¸žLܬüÆ ì×Õ%#1n ¼ô¹r~h-$z=Ôc28D{·À{õ½d} ˜xUüN™|eI¹h­S›fŒ)|fxf§•»í*z#ÇÆ®g?Güæeñ[ƒ½> b¼¤è`Y™Æ«g¡»ŽÉ/t*¿ùV´Ë褻LÍÊoï\’·û–h›„MÆä’¹a1Û»/iScˆìGsÌö³Ž‰×Åï¼¹TV)©2M&ñhwϯ)vjåø£hÑ96v=˜ž#~óªøí/ìÕ϶¾WŒé¯i˜ŒÔ|s¯QÓO;z#iÆ®‡S³òÛ{1!ûUÜÌa¯\À“º>4[Œ°9WζrÁàÈX·“ÿ 0­Šß~fáeÕ>õ¼¼+Wš&³ m/ÿ™]˜s7Çø§½‘cc×C€é9â7/Šß~u$ycQ#ÿ±˜’Z™&ŒIèßdŒÉo‰u’&ý´£7’fìz05+¿Ñû!aJYÁVö­­œ3&´óVŘ€·ÄogLJüjü,ÀWÓrÛcp){s©P6Š«L³iÏ”îI<âP;9v÷2)£7rlìz0=GüæUñ;ùWŨHHÅËÊ4aL˜ñîOM ]šÚÑI3v=˜š•ß><ÁNùÔ)‰Ój¢‚1‰úL9oCIÀ[ÃüÉùÕijâo6ŠãåÊoL¯Y眨¦Ê4aLø.üžö,¹§1ÝåÜeôFŽ]¦çˆß¼*~yÙ"P -&XÔ¦ c"»ò›{§réR´«èuÒL\ϦԬüƘl;›RL‚2?+‹HP¿í.¼[ù>îÃ%¾äõßÜÊ¥UñÛ'oåœ%Š,jÓ¤KªêÕjئÜ9`I—¢]Eo䨨õ `JÏ¿ÓrÛz¡#+Ûž”¦ c"åûhÛÏ”:«Yº{™”ÑI3v=˜š•ß@ KEà­_ï0&Ÿß¢÷íôÖŠ»ŒÉ[}‚ûÊß,H«â·_sä@)Û†¼(°¬L“.©Þ¦êfL¸—c—¢]Eo䨨õ`zŽøÅoфɸØúŠeñ[iš1&ý0¦Ø»’’è§½‘4c×C€©Yù†¤IŒ7ÍÜŒ ½Ï›íÉR`λ0úvΠIu^¨ð/À´*~3Ù^Üþa ®,°¬LÆd4ÞŒÉ;9v)ÚUôFŽ]¦çˆßi¹òчj¨­ìÅþ¿6MP¼·dùÓ¹`™îrî2z#iÆ®‡S³òÛ°Am;‹d”Gh«\À±…ü\Ü“äÄ›,ш%».œ£KTߦUñÛ˜ˆWECYÍ0•¦ c"ÉŸI< ½.©éR´«è»LϿӲø-) b{ `ªLÆ ïÛÂh/inE»ŒÞHš±ë!ÀÔ®ü~µ¶7tȶÄo¯‘ô†Ý`Û㉲ÙÉS¦øjÞŒñ‹À´<ðÒ‰Ÿá¥2þÕ1kÓ„1ù\ðÿïžÄƒÝ­Ü=ŲŒÞȱ±ë!Àôñ;­ŠßÈFýÊF.€©2ÍSüôüöN€£\¹í*z4×3€IÚ•ß@I„1rök{Œ r¦ 1Û&Pâî]9t~éõ^CÕ¿ L²*~kowD’ `ªL“.©¸ÆDÝÚÑ96v=˜ä9â·¬ŠßÉOð˜Å–é‚1•¦ c üéÇD!ôº Ê¥hWÑI3v=˜Ú•߀˜Õ÷÷€âžß9¶ØfØh“ìNâE£ZÑäýjwYíùmdÄ^yÛØ:fmšM{¾»-ø¥qŒar5ò®¢7rlìz0=Gü–ÕÊoÒ¤öÛ‹ÏáoUnm¯f¤÷êŽz-)ä*箢7’fìz0µ+¿A‚·jIÆ~dÞG²`L¶ö ú-‰»§r`D˶ò1 }³»€¬Šß £O¸µ_ÈÛ¼ý=•+MÆ$,Æ„±7ðB.E»ŠÞȱ±ë!Àôñ[VÅïÌB¬¤à ìÿSe¯fd¯à]c‚öFöV³KÑ®¢7’fìz0µ+¿_Ê˜ßæ iaìdÁ˜’mX¼õ¥í,òGì]J²Øˆ#ù¡¯ÓrÏo5.m;?2Â[^â-M³I<ÆäÈÛɱ»‘w½‘cc×C€é9â·¬Šß~ÛÔK³QØ¢À²2M}S~×4µ’æR´«è¤»LíÊo€ìu‘%*nV~{Ñ–Ñ¬×ÆÂhè.cŠ~î²wHÿîVn¹í C´MmF´¼(NåJÓ„1y«»ç—wvéäØÝˤŒÞȱ±ë!Àôñ[6Úž )§²çwiš1&á_ÆDÜ)È¿½LþF¯“fâz0åNå÷‹ßÅìS öÆ7c"ñþÞ¿Ò0ys¯Ñ¥Á[ $Ž_¿óªø-¯]’x_œ\\â­LÆr¼ïcιr9þ´£7rlìz0åçˆßy¹ò9‰7,Å]¹Ê4aLLúaL×(çFÒÜåÜeôFÒŒ]¦vå7„ˆ)½ä°u%Å“7Öõ²m”kŽÚÞ]9oóÀ>×¾Ú(./·=ñ ïìÂ5”å•iÒ%Õv¸w]'îµÖÉw/“2z#ÇÆ®‡ÓsÄï¼*~c„„)ÑÛd”[¹Â4cLñ³ÿGÉÚ[Íè§½‘4c×C€©SùMÑ_oC²Ù]lWá×#|ÎYÞFð:•3¦å“e5h˜Žú`ZîùFD‚凿\LI©L³Ù…àfLÞ2µ“cw#ï2z#ÇÆ®‡ÓsÄï¼\ù-Œ šC&*Å•¦ cJéSùíd¡³ÿÏw9w½‘4c×C€©WùqÎì3Â7{~C$¶Cÿñ˜6úž×v$l›“ôMñ;/·=1¤uÁ-& Å©\eš1¦ôjß¿óÝˤŒÞȱ±ë!Àôñ;/÷üNÀ¢¾¾2•såKÓ„1ñÝÔìÿ^÷ã{«ÙÝÈ»ŒÞHš±ë!ÀÔ®üÆäõœB†0¿J[0¦ 1«RŒjûãÝÊodgJÞšÀ–ÿo^IÉ«â·ßŒµm¸³ÇT– ”¦câüј¤Nk¬?íè»LÏ¿órÛïŽá¯>ú½í¿Siš0&[Üï$¤nK ½{™”Ñ뤙¸žLÚ®üFoÅDd¹¸%~c Á¸’½v”¼Tr—1!³äl/.ÇoöcÒUñ›ÐúäÈE¹@eš0¦ p5s Êo?í軞Lúñ[WÅoÛt¥D™üˆ£(°¬LÆDïý¿S¯Q¼^Šv½‘4c×C€©]ùí#tQ³m7¼‹ôc²˜>F(‚Š_.ÚÕ˜T”’Ú/ðÕaºÜöÄÞw$/©l{Rš¦Óž?,|ÔR‡•ëÝˤŒÞȱ±ë!Àôñ[WÅïh_Ù HñïjV›&ŒÉöùØú«Ù¥hWÑI3v=˜Ú•ßF[l7+ö1PæÍ))1'ðv ÿ?wÿÒ#Qd‚{ýŠ\N,2›´i̪f3hh³ÔUYèj”*5©Rcºý˜]¿×ã ’—¼AÝ/•Í-"ÜÍÏ=<4s*ÔÕ»röÞ‹@28tñü“À4+~£7¿«Ú'˜Š^¹zi4í9¾}åÝÝåîáw*ÚUöFõC7¦çˆß:+~»Ç‘ûæÛÎZË>¦riÀ˜@éòÊq«³›ý¿žŠv•½Q4ýÐM€éÆó›%D—yȯ½-2&±ïIðƒ"p“UÆ„Y3sŠ >º•›¿³Û¯ ø%o#9ÅK¹4`Lö×½§=Å;`J_íìë‡nLÏ¿uVüÎÙ¾B˜ª¢)—Œ)Òû&<ñÍ>í*{£hú¡›S»óÝ ÄžÃiâŽÁ˜8‚m,Ø6¯˜—çÊ¡?ýAì;üQk]îüÎ É(–CUë¥c¢ŒWˆÜüêÕÎ]foÔX?t`zŽø­³âw²¯ŽFû棖ßÕÒ€1ÁëÄãiT „SÑ®²WE3 ݘ þèNÉ“ú¤·FXdL1EqÛ¿!¸Ö`yhLÕs8|ðTîüxÆ5–²Ïe°ø RZëVKÆ/‰àp°Ðó®O£ÆNE»ÊÞ¨±~èÀá1â÷ù~‹&{( "³3¿ê¥c ”ÞŒ)JlkLöñµ³7Цº 0µ;¿)øÄt¹mC¶Æ˜r2f$B̶ tÆtS mÆ”Ýr%‹x·üGiÖöγ&¤%+¯–ŒÉô.Æîj ¿ÚÙ5Öݘ#~Ÿï÷LѤ˜ì1᪄–ES.õŸf˜r¸èKoÍÕÎ]foM?t`jw~sôþFûµÝGcñ®œqCcJ"~_.šÊ40ù¨FƒÅm/©Ÿœ+w~<ãs—…ä&æ„LeS¹4Ò˜òÛ%Õö»ØnIpy™”Ù5Öݘ#~Ÿï÷¸h²KÊL>/(^9õRÿi†)ÈÕ¥ YC»+‚|µ³7Цº 0µ;¿ò¤ãö A /†”wål;Á2ÙÐ0-d)©ÄH¶ó¥Þ•;?žq%°'Š÷£{ouLÕÒˆ1±¾;¿{ojìl箲7j¬º 0=Fü>ßïqÑdŸ[àMGþ|.4¦jiÀ˜Dõ:•ƒœoŒâlÿÕÎÞ(š~è&ÀÔîü&’¬ès'“¬y~ÿù/8'w îŽ+«ŒÉUûb"ý(cšîüNÙ"È ‹»rÕÒ€1Å@ïiÏYoîÊÙ~쫽QcýÐM€é1â÷ù~‹Æ˜1H°OÁþ]0¦riÀ˜Xø:Arü`Š—‘w™½.šAèÀÛßD²1&«uÕ¥¹r~:€úßÝ–€Éòa- Bœ˜ü `ŠÓß{tÛãêgçw¹4`L§eóù.ÉÍV.^íÜeöFõC÷¦øñ;ΊßÌYôBbOŒŸÀT- ¿œ\_æ°t·•‹§¢]eoM?t`ºéüöyæn]Â!ãâ0‚ ÖmŽÉ³+ŒÉÉš±´ñ²ý0MÛždÃgWÝ¢“xꥯ¼mŒ/VîPrsò//“2{£Æú¡›ÓsÄï8+~sdû<ÐvÖP6XVKÆDò¾×åæ°74;žŠv•½Q4ýÐM€é¦ó›„Y”`IcòvTNÁÉö¯qÕé˜ßdd"Úÿøè©\œ¿íï€Ð•¯ÂÁ¢^Lâñ£Æ‹11èÝÃïT´«ìë‡nLÏ¿ã´í‰b~¹’•î‚õÒˆ1… oÆtgñò2)³7Цº 0Ýt~KHFš¼ÑÁÌ¢ÆDJ”ý¥ÆJ`éïáeï_Ja{ ?)~ÇYñ“÷zPŠTl媥Ѵçôö•÷1ô7íñT´«ìë‡nLÏ¿ã´ç·•03ŸÃ]žÊ•K#Æ”4}3¦£xÛ`|µ³7Цº 0µ;¿cÊ •Ðyž,Mâ=.áÝòkîÂ)®º D¶m fw„ú`ç÷ùñŒk,eWnÙŸUm媥cÂðv°$À»^¹x*ÚUöFõC7¦çˆßqZüÎÞ¼!ì^…Sµ4`Ln2y1&¹í1KÑ.³×E3ݘ Ýù}DŠmRŒgcE»€}| 9@X2ŠóŸŒêÜRÄoUr+Óâ·çÀI¹ú§ø]. ¤€c²7©í+oïßW;{£Æú¡{í*{£hú¡›S³ó’m ܘÁ-¸×ÚŸìzš7o.:Xúi‹On’¤ŸFp~<ã3¢ s°M¦Ëm?5¦ri4‰‡ÞSRÐØÍÍ œŠv•½QcýÐM€é9â7Ì‹ßÞêŠî[O¥µn¹4dLð͘^3æEƒoE»È^Í t`Âfç7ˆß ÛŽ¡ß¦]dLä'9«†]dLâ# ÜVϯò~Ð(îüxÆ5–„%ÛÎÒ>ƪ] Z8X¤ˆïIñÊ)À'OåpVüÖänmcšì[ÿs+W-¦=ƒ~O{æÏoÀSÑ®²7j¬º 0=GüÆYñ2{NhH!Œ©Zê?Í ‡t=Í Þö˜Pøjg¯‹fº0Q³óü~ï ºª1‘¤à‚°}WÒbç7Ø’4cÖhŒbh¸ò `¢iñ›4åèRy³^0&á·ç7ÊëºN«Æ.E»ÌÞ¨±~èÀDÏ¿iVüVÁvÖì¾¢…ÆT- SÂ÷”z÷4£SÑ®²7Цº 05;¿ÁwqêÈä5&bdv󚬸è.A²ýÄìMøQ?&š¿Ñyˆdˆ…¯|½4šöŒx5œ"©ÜÓ©hWÙ5Öݘž#~Ó¤ø|òÈÑîsé.X-“~3¦»»rD_íì¢é‡nLÍÎï¨.Dª~3t|c­`L¬¨9ûlØH¼8W怆à ÜnÅHì'i¶óÛÑ|‰æDESµ4œö ×}Lô¦¦›;Û¹«ìë‡nLÏ¿iÚóÜHð‹BX^â-—ŒÉ§x¿ÈÝVî2ò.³7Цº 05;¿y@Ñ›DïÊ‘Äh„Éo©žžC Œ)&N~Ÿ%bà8žh÷`šíüfoÙw½Ì>â] Z1¦ô͘ä˜Îvî*{£Æú¡›ÓsÄoš¿É˜¤˜ü¥ècª–ŒI‚\}Lö•Š7픿ÚÙEÓݘšß‘‰}¯ˆË=‹žßÆ´¼q[KX¼+Ù½Ñ$åˆù“§r4íùÍ)Û’ý1˜ ÆT-¦='|ŸÊ¡ÜjL—‘w™½QcýÐM€é9â7Íw~³€=aAS*€©Z0&ï5:¿D¶“É7Œ‰ßíÜEöºh¡{7;¿¯Hp/ ÒkÃŽ ²„軋Œ Ž.fÛJ¢dý$câiñ;hÈ*®y.©õÒhÚ³¾·¶z×`É—¢]foÔX?t`âçˆß<+~£ý¿ œ’¦ràeµ4`L @oÆxW4§¢]eoM?t`jv~GöSâòõÒ0÷fôÛL}ë²ØÇÚSß>‹³|´Á’§mOŒ„DFÃX)¯¤TKÆÿ 1¾«±ËˤÌÞ¨±~è&Àôñ›g;¿EíÿÅ4§rÕÒ€1ãõt÷ß1¦³»ÊÞ(š~è&ÀÔìüÎähÌ5Å¥ÝØË›Ñ;´w”׬uí'Ïrb£™ñ[¹}ño€iVü6Þ§NÑ}HSµ4¸] ß §ñî>&ŸŠv•½QcýÐM€é9â7ÏŠßâ=ÊöõQÛ,•ÀT. Ó{o4¦pÓ.À§¢]eoM?t`jv~³ºW>¥` šd¡éåÍx8ãÆlÿ¾¦ ‡œØ¶‚Am·õI`š¿3Û%ÆÃ ¦ðcª–FÓžÿpS™o¦¤pújgoÔX?t`zŽøÍÓ¶'Ù«ö=^¹Ð˜ª¥cÒðÖ˜Œ-Ü=Í./“2{£hú¡›SÛóÛÇ›ÐÑ#´"½“œçèî׌é¢A‰î•â—çOÓ´øMÙ ë7¶Á-4¦ri4íùö7Þ=ü.E»ÌÞ¨±~è&Àôñ›gÅoIÆt„ɸ*^VKÆdm¸SÎéfÿ/§¢]e¯‹fº0I³óÛ-³y4<%]À–×]9ÛÊùóÛý+ãbçw$1ºæþ•¶ñÍŸÜÊɬø’qÇä#‚m?^hLåÒhѤ‹1åHµjìT´«ìë‡îLòñ[fÅï”(†…ÅÍïjiĘ^·U_Œ)‡›9í*{£hú¡›SÛö„ü\-±_ñïÏäÌÊc2\JÆ› ë㚃¥målÏ‹ÌI1Ǥݟü`š¿5EÖc¢cq*W-&ñè{j $H7¬\ð«½QcýÐM€é9â·ÌŠß€î´ˆ)IJhê¥c’wç· ºcL§¢]eoM?t`jŠßÑ}Þ€9ˆûÏ5ÆD ÙvJœBNËÖº~€ioYÔë˜ôCÀ4+~“As‰÷jÿ¦ji8íYßS²½×MŠv•½QcýÐM€é9â·LÛžÄÁ¾;ˆ¹&ë¥cBúfLt[4——I™½Q4ýÐM€éfà¥{½Ù¾Ã r×¶rÞÇäWJÕØRÄÅ))öÝŽíàìÍÊÂ~ƒçƒÀ4+~&ÃZ ©°Ö©—FŒ ß~L 9ÞmåNE»ÊÞ¨±~è&Àôñ[&Åï$9$¿"\Mµ4bL)ð›1ÙÎë¦hòW;{£hú¡›SSüöé à_ˆþïEÆ$àÎÓnöfŒkÑ(Î ÔýÉ·’yø“LÓ/“b߉+”wåÊ¥c"Â÷´gÉ·Ó5ŲÌÞ¨±~è&Àôñ[fÅï…¬Å>p-4¦jiÀ˜0¦ëíwnNLÒ©hWÙ뢄îL©)~»F¤R0€XeL¶ýskt¿WY´Ö''lìU3„¡rþ `JÓ/Ù¸#*ùVégKJ½4š]ÈïÝ)HÈ7¬<]S,Ëìë‡îLé9âwš¿SÎb{u²-C”B˜¬–Œ \–Ñž;7=& ¾ÚÙEÓݘš¶'É`¼ÅѶd!¯ö1% ¨ª~{QcʆiÉ«ÌÄqkço€iºó›£%?’/^–K£iϜ߳ %Æ›&Þtµs—Ù5Öݘž#~§YñÝ`ƒ5«ØÇò“1UKÆ/ÁûŘâÝþ?ÑW;{£hú¡›SÓöÄÝ<‘“!©ßZ[ØŒ)ƒ½F§‰ÿŸŒÉ˜%ßéðÖý$0M‹ßÁˆ# ºãBñð«–FŒ ãÛ%ÕYéM]Šv™½QcýÐM€é9âwš¿CðþdŸÚ ècª–Œ ä=‰7¦pg—NE»ÊÞ(š~è&ÀÔ¶=‰Á¨ qÌ „K/1e$ÿSÑ þº6]4Ñ~*ÛþB§¿ñ§€iÚö$ø„=ÿ·Ïgþi{R.ÓÕ×u\wÀty™”Ù5Öݘž#~§ÙÎo1É]JB*ü˜ª¥czuâŒÉ¾Qwûÿ³»ÊÞ(š~è&ÀÔ¶=±ÿ»uRï+Zõcâè/KnýM«—x1²=!Ð~ôåÖ÷)`š¿YXŒí¢}€Z°TK£I<é Ծ˽écJ§¢]eoÔX?t`zŽø¦mOP݊ƾF9ý<1©—FŒ Ò»óÛ ä¦)‡¯vöºh¡{SnÛž„ìíHnF©Ãy¸•ƒ¥Ï]$ߌ¥¼x%Ŭ©ìóãTÅ•K£Ù…‚ß³ %ÝôÊåSÑ®²7j¬º 0=GüÎÓžß QÑhlHåˆðjiĘÜûïdL¬p÷4»Œ¼Ëì¢é‡nLÍÎoãJ₈ !–Æ7cB kOpÛ#/ù1®ÆÉ¯-ºÄt^¿ÿ0M¼Lìnž9kââä·Z1&Èù͘0ßXëækŠe™½QcýÐM€é9âwžöü¶mµ‘b£±¡l°¬–Œ)؃þbLŒw=&ù2ò.³7Цº 0µ^Æ]&PÑñØÉŠ1A">L>”`ñ®\dB±÷J%|Xcš¿1Ûþˆ…±¸(^/ñ» Iï€éT´«ìë‡nLÏ¿ótç7ØóUÅgÝ–[¹jiÀ˜¥ðfLxwWN¯vî2{]4ƒÐ=€I›ß`ÈÀÙh¿°¾:‰×ÐŒÈØ‚Ä´$~ûOÖÕÍœRJøI`ÒYñÛÈ£’œ •#ª¥AY-¼ÀÝ0_íìë‡îLúñ[gÅoh{uòãørJJµ4bL9½§¤øç|S4§¢]eoM?t`j¼ûP¼×F×T£‡>åsñ®@ŠèZLÈBícÒIñ;Ã1—8¢ïõžÊÕKÃiÏúfLQà¦]@ñ«½QcýÐM€é9â·NÛžøäM(B9"¼\1¦˜Ó›1ÅÛ§ÙåeRfoM?t`jv~…ä>-Vë¼Ô.à§r>G/©¢mÊÖ.ñÖëQYˆÏpµßÓ¬ø­Ñù#øµæPl媥!czOâ5Ât'~ë©hWÙ5Öݘž#~ë¬øÍœ2“¨G,ú˜ª¥þÓ,*å÷]9âtL§¢]eoM?t`jv~ƒŸîª€ó–¥vïcb Æ9gË~Lì§Þn]uÜþ$0Ív~Û)‹Q?U('ñVK#ÆÄßžß¶g½éüÖ³»ÊÞ¨±~è&Àôñ[§;¿!¥œÚè'0UKý§™Ó[còïÖMÑ\íÜeöFÑôC7¦fç·Á{{$ÙÆê»À˜È¾&)ÛÎÕ0-.ö1šÛô³4åOžÊé´çwV·ZvÍ,•}LåÒ€1%~_j†ùîáwy—Ù5Öݘž#~ë¬øM1Ú)Ù“ËvjiĘ^Ž‚'cÒ60a_íìUÑŒB·&¬?ºƒ1 ·>÷ñ“Ëså$eïÞæœÇ7ø|pð—k¢¼50,ú1¡íÑÞ/ûš Â';¿aVü¶m’·üR0´,OåÊ¥!cÊ`LwrįvöFõC÷&xŽø Óâ·±‘ä‰Õsá.P- “íÞ}Lè†fÃ¥h—ÙEÓݘšßÈn… þ;[Á/:XÚû˜3çÄ)e†UI€ ýïG¯¤À´ç·'cpþ­//ñ–KÆD ïS¹|7¾ á2ò.³7j¬º 0=Gü†Yñ›$ û3{ü”–åÒ€1±¾'XD?¢»)šSÑ®²7Цº 05;¿ í‘ä×»–.ñnÖîöf„‹ §Å»r(ÞXA¶Ôøú ˜¦mO›_0 XhLÕÒˆ1~×X†Û‡ßåeRfoÔX?t`zŽø “âwRŒöŒök±•«—Œ‰ù=56Úãú®h䫽Q4ýÐM€©Ùù~þœÝQy¹É÷Á`ß"¨¸ª1eŸ’¼ÝÀ ¬? L³â÷Ñü}¨p°¬–FŒIâßmåNE»ÊÞ¨±~è&Àôñf;¿}§a‡ A¤òc*–FŒ)ÊÛ] B¼¹’ù«½Q4ýÐM€©Ýùrb{ú&dX<•ûsEÄåï¤ËS&GEdûÍ"² ¦;¿!óq@™¸òc*—Œ ù[cr“®›»Ú¹Ëìë‡nLÏ¿aÚö„ìÿEâÜðçV®\1¦ðÆïžfxy™”Ù뢄îLØîüö±YÔ¶UÇvm?‹&ª}IØP Ø‚VS îÓO9†Ï2&œ¿£Ûû…Ò²©\0&üôçD|ÓÇ„—¢]foÔX?t`Âçˆß8+~C²»íül»cª–ŒÉ¾ ïS¹à©hWÙEÓݘÚß™| ç#Ràå³À˜Œ#j4\IY„×,í'kPòéÙBˆòÉvœ¿m—äGhÀn󘪥ѴçôÍÊÄ;`:í*{£Æú¡›ÓsÄoœ¿-:’o’$ –ÕÒ€1Ñ4¦ð* VÑ\Šv™½Q4ýÐM€©ÝùÅ%1°MÂâ©Üñ•ËÁö1æå>&Ûú ¦¤”>9ðòüxÆ5fLÄg•*)šxë¥c‚ïiÏŠ7}Lx*ÚUöFõC7¦çˆß8m{’Áèˆo•¸¦jiĘðj ¤ÂéÀß(šËˤÌÞ(š~è&ÀÔîüÎRòÖkȶ©ZdLF“”ƒî•Õ»rnš™ÝûÒ¾aÕ˜pºó[Üï7áñ¦ü¦ji4íYÃ[c†»»Ú¹Ëìë‡nLÏ¿qÚó;+h¶oA”Pl媥c úöʱÜcºŒ¼Ëì¢é‡nLíÎïÄÞ€íçbeñ®œ?WÔX“ªmyùT€A½Ý “|ÒÁgÅï@د¶9Þ–[¹bi4홾û˜$òÍÉ/êW;{£Æú¡›ÓsÄoœ¿#úv&‰‰ŠÎïjiĘB~÷˜„ÓO¶.:í*{]4ƒÐ=€‰ÚßIÐþ¿ y|•¶`L!«kæ9y?ÓÒÀKgLl—-Aíü¦YñÛ@Ùvá1¨V×žŠ¥c¢³]À“”´k,~µ³7j¬º0ÑsÄoš¿£€!å\ #¨–Œ ‰.Ƥ¶8žô¢¹í2{£hú¡›S»ó;å@£œtíJJø‹{v‡lc¡˜ŽÎï›jh3&‡-o{ð“ –4/~'ô¹å~O§bLÅÒˆ1±¾g ÈÍÉ/½í"{£Æú¡›ÓsÄoš¿Ù6 )dô®<-4¦riÀ˜0еÿWÖ×`ÂFÑÐW;{£hú¡›ÓMçwIÝÇ2å‹–„1aB6ŒÉÇàÐi`r®Æ¶¥¶ïAž¸ ó`š¶=ôGeH†$?[Rê¥c ß}LœïŒâèò2)³7j¬º 0=Gü¦Yñ;Ɯɇ#f{>[¹riÀ˜@¿G¾¦SÑ®²7Цº 0µ;¿ ˜ro“ä–€)ü…2&L1£°m[h1ù¨ŸÅloÙ'‡Фøƒ¶ÛwŸÄ~±Ÿ5V-¦=ë{2qä$7 –ôR´ëìë‡nLÏ¿iÚóÛÇ ³G8…S±4`LpM°Èš^¦q¢¹Œ¼Ëì¢é‡nL7߆L1ÀË|{q‚ )Ø»èD‹ŒÉ-…ûø§ONâ=?žq%ñ'‹áXp“ª‚1•K#Ɖ¾S¾Ó˜®vî2{£Æú¡›ÓsÄoš¿5€=ýT‹£ÜziÀ˜¢¾ï1eŸÓÕ&>í*{]4ƒÐ=€‰Ûßb;[´o’q¦EÛ ä³Ç}–ÉÕ’èFãöqäO6Xò¬øm¿’ýEîcî~å]¹ŸK#Æc|3¦×øô0qüjgoÔX?t`âçˆß<-~³j3…¹¦jiȘ‚¾Óy§©Q4—¢]foM?t`jw~³Oêö Âj_àÅ+)¶¯Ca‡%†5`ru }F­ßhÉ>Ù`ÉÓâ7£aHÞ7Z0¦ji8í9½“ïºn€éR´Ëìë‡nLÏ¿yVüv…Üèß` `*—FŒé5²ùøjÙŽn€‰¾ÚÙEÓݘÚß (¶BÛ‘.ÚžØÎ•³Fúmw]¿ý'kFˠl°äiñÛ-þ}ZºÁ”[¹bi4í™ðí’J|7WŽ/E»ÌÞ¨±~è&Àôñ›gÅoÒdô½ñ>Íê¥ÁÓ,²\“x3%¸cL§¢]eoM?t`jw~£·6øV.ØÆl©)üÅíÊ4ú‘mÆŽ/ß c2ô>&?yÕGû˜x¶ó;å$b[qc%T¶ ”K£I<á͘âݵ'>Û¹«ìë‡nLÏ¿yÚöÄjŸÈxlNTÅUK#Æ„o·Å z«1]^&eöFÑôC7¦vç·û!ÚÞ\»ßñ/“ Ù÷$C ¿½µÈ˜ì?U÷Y¾öž}˜¦=¿“}ïC"Û*•FqÕÒhv!ŸÊáëzJ ˜.#ï2{£Æú¡›ÓsÄožx)~¯Í‘F)Úª¥cººrm’oNåäšbYf¯‹fº0I»óÛèN ˜Üb˜ui+çí©Þ.€‚Q5à*c²÷‹e²½ƒ?ɘdºó;S¦¬X\{ª—FŒÉ¸ÍŘð|c5vµs—Ù5Öݘä9â·ÌŠß S¤lOÙâ(·^<ÍB†kÿŸüDè˜NE»ÊÞ(š~è&ÀÔìü+t Þa¹ÁRQý¾²![×´ÌÆüê°ºïl@ý(0ÍŠßê¾w>ØhIÑ`Y-&ñ(½5&&üjgoÔX?t`zŽø-Óß}2¢í×íÿ[¹rið4 ü~𥄇Q| ˜®vî2{£hú¡›S³ó²ï £_¨•¡]œÊ©úøEc‰_žC Œ %e2'ÆO¶ ȬøE£ø-ÙrÁ˜ª¥ÑìBÉoÏ/{NÝ\IþjgoÔX?t`zŽø-³â·ˆdÿHP‹K¼ÕÒˆ1!_§rnvn€éT´«ì¢é‡nLÍÎoH~Hiä…ÔO¡×S¶o‰·Îé ‹}L`l•ÓÑ:ÒGmOdÚó“*%ß&I!~WK#ÆßöÖ܈ßry—Ù5Öݘž#~Ë´íIpú꺲í `*—FŒ‰ô͘DðNcº¼LÊì¢é‡nLÍÎo¤HÕöŸö^´=q‰I4`tÛïU X “!›7ý|²ó[¦Åo¤l{R#Ñ„0UK£Ù…ö†^Œ @o:¿åR´Ëìë‡nLÏ¿e~àer¿cÛnP9Œ Z1&†7c²Ý„¶)½§XÙ뢄îL©Ùù .€„ †Jīֺ¶LîØ dñ´t%ʼn€w RfVúèø¦4+~ó±ErŒõæ‡âT®XÍ.Œù{ÚsàË¿ÚÙ5ÖݘÒsÄï4)~Û“Õ@Œ¢Ê¥0Y.òõ4³=ÄkºG£h૽Q4ýÐM€©Ùù `Ò8ž„¨:†‡ŸEÃ1EpÅ{‘pÉöIJ‚œ¥”? LÓß1Ú‡‡ö|‘P4XVK#ÆôÒÜ^Œ)$¼¦«»ÌÞ¨±~è&Àôñ;Mw~c¶¸ÖºÕRÿi¦YóÕsãì›Îïtµs—ÙEÓݘšß}«ê‡•Kâ÷!Pù÷$iƴȘì…Ù¶¤j´õ£À4+~£=±Ð¥/ EKJ½4bLAßSR¢Þ™&þjgoÔX?t`zŽø¦=¿Ý_ƒ3z›p9W®\ê?Í4‡ó&¼1&۪ߴ ¤ËÈ»ÌÞ(š~è&ÀÔìü>öÞ.`àÓ¢»€}ã¢Ï9fÒ +¶'G£¼oåÔÿóµŸþ0ÍŠßdÞŽR¼¬–F³ Q¿'ñÜŽoJ§¢]eoÔX?t`zŽøfÅo²½FBߺWîÕÒˆ1½ÜÆdOí»­Ü©hWÙEÓݘšß‘ý¦º`°}(ÄÅKw Rû†¸ÝžÈâ©\äcכĀã³#ÂÓ|ç·¨ý§7ÝÆRü.—F¾ò/;ÐczyÌ·€éÝÎ]doÔX?t`zŽøfÅïR"ô“i•ŸS½4`LIŽÃ‹1…×éI]4ùT´«ìuÑ B÷¦ÜìüŽèöÑèlIÂªí ¸ý$Ú;è¸F‹~LöiòǾQ…Onåò¬øíÑ(´ƒî~ö1•K#_ù,ïI<÷³ ó©hWÙ5ÖݘòsÄï<ïù­öpGÊn-RhLåÒ€1áˆÂsÉñ®] ¿¼‹ì¢é‡nLÍÎo—R½/Ô§(2/nåÜ[@ ŒÙöÆpè( –ö¹tœ>ɘò¬ø®ºÚæ“ò ©\1¦,øÍ˜àæT.ŸŠv•½QcýÐM€é9âwž¿…mí­/¡^- “íèdLb;¯›Ë|)ÚeöFÑôC7¦fç·Ú^.{ËÞa¨vy›M „rf1d F¼S~ˆ™"'CÆ2¦iÛdwaƒ\Ì.¬—FŒ‰Ò÷ì„7§rùò2)³7j¬º 0=Güγâ7ÚÂ/dQ$(¬u«¥c ‚—w=°ùFcʧ¢]eoM?t`jv~'"òÁS‰õÝ?U4þ { RÎ~KչϚƔm+’ÐA¢¼Û¤o_ü`šîü H˜ /«¥c‚o?MFqùjç.³7j¬º 0=GüÎóâ7e"²Ç³{æâw±4`L!GÛÆ˜øœ˜Ú(š·¢]doM?t`jv~³o>•)x÷cÊ)EßUÐqQbQc’ìÛ8Ÿýd;àðQ`šöüv*’؈/'¿õÒhO oK÷Á½¦ËÈ»ÌÞ¨±~è&Àôñ;ϋ߮fD œJ©Zê?ͲŠ~3¦nÚô­hÙ뢄îLÚìü&ÛÆE@ñ!Lø…6U4.€ˆ“q‚Tóg‚ízíÛ«öjàÈŸ&¶=‰Þ;AÊ¡lâ-—F³ %¿û˜lÛus%E//“2{£Æú¡{“>GüÖYñÛ/{’·Íx¡ý¦j©ÿ4ËÌñêcwã›ôT´«ì¢é‡nLmÏï,ÎÝKÊqu1ž°ú¤³€áÕk°0‰—2 ª:&ú}ÞOÓ¬øm›Z7ε÷¢ècª–FŒé5_á0‡ñ6Ò›;í*{£Æú¡›ÓsÄo¿Õ­í3‘²ó»\0&Néjà–1]Šv™½Q4ýÐM€©íùHHS–ì—CWSJJ`t‰1å1éùɘ($ŸÖî_yˆj¿¦Iñ;·Qñ»ÌÉ­ÔXµ4bLF%Ï?IS‚—T})ÚuöFõC7¦çˆß:-~“[Ñœ—„ ñ»\0¦¨pʱ¢ÞÍ¥h—ÙEÓݘšßäþ‘>BA¿g4NMTußôFƒkVßtÑ HtÏ~uÒJÃ}ào€i~ॻK)Rˆ©¸]P- Ó÷´çÌáæÚ“¾§XÙ5Öݘž#~ë¬ø>±†ŒÄFH…ø]-õŸf)¿æ+úoÎFˆoÜôT´«ì¢é‡nLíÎoôË Ù]»×“§iʶ‡¥z Ž»r˜ˆCäHaüâßÓ¬øbÖÄÙ'¶,õÒˆ1a¾Pþ蹩1ýjgoÔX?t`zŽø­Ó¶')€ßE±ïA±•+—úO³$0ù7ÞÅQ¸¼LÊìUÑŒB·&ª?ºƒ1[Q4šÇ¶û ­HG’Fã\j_C:†:.0& 9ÛÍÆ1‡ ÿíÀt~<5 Q‚%ƲW®Z1&à|1&¿pScñ«½QcýÐ-€‰ÂcÄïóýž(`Û#rá•S/ “=èߌ àFü¶çÑW;{£hú¡›SSüN9”z“ƒÕz\&#=Þ™ÉÞN’´¶•ûó_à¸Thû^ :ôLù 0M‹ß9k Á;÷«áåÒˆ1^ßªáÆ¾™Â¥h—Ù5Öݘ#~Ÿï÷¸hŒ¨û°)7' ÆT,õŸf¢¯;£c Ûâ7…KÑ.³7Цº 05ÅïÈF“ŠÔÕl9S"Û³bö«Ë–Nåþür›qŠ”‚gÞþ 0Ív~“ýÈ>éËaÕÒ1Qz3&Öv/…³»ÊÞ¨±~è&Àôñû|¿ÇE“ˆ0¥Š{LõRÿi&>4ðülkL.#ï2{£hú¡›Óø ɯ࢈¸LîÇd»bÜd<‘tA :¶r~«Ðø*S<®~p+7ßù-£ h./ñVKÆ"ïS9?Þ¿©±w;w‘½QcýÐM€é1â÷ù~‹ÆMŽ‚úí˜By%¥\0¦“œŒ‰o,)\Šv™½Q4ýÐM€©)~CVR†ã!±ØÇd˜FIBbä,´pŸ_½F¶’éJ/ïÌÓ¬øÓᩉÁ(ÎÏõÒ€1ÁÅ ½¡×ݹÚ5v*ÚUöFõC7¦Çˆßçû=.š$F[%WG¹ÅÒ€11½óß\I¡xµs—Ù뢄îL±)~£¨k&C‰KíŽj’°‚‚…&¨×0Äì½L|42}˜âlçwvË<͘Å%ÞjiĘ0^ RÃË<¡Ucg;w•½QcýÐ=€)>Gü޳â7B¢r–äÓ ÆT, „põ1‘½ð˜à«½Q4ýÐM€©i{bO7ò›rÖ“#H¾cà!é)Ä’Ï"8mD?L³âw¶ç¤7|ø´ÊÒ©\1¦ÈúfLx L§¢]eoÔX?t`zŽø'Åoõ{YjgR(,)ê¥þÓŒø:~²ç¼ÞÍKÑ®³7Цº 05mO(“›H‘=Öí!¿€-¯S¹ÌÃÀµ¦EÆ„¶¥f!¶ŸÔ˜â¬ø ö_“ÀÒó»Z0¦h×ù'eÊw,ñT´«ìë‡nLÏ¿ã¬ø9úѶ=¤SQ4õÒ€1E‚oÆ„Ôîü¦x*ÚUöFÑôC7¦¦í ¡íÇ ”9.´"½ú˜8£‡Ù•dQc¢`¯ ††n1!eL³â·²Ÿ‹xS–@¡1UKÆcºÜ2º9`‰§¢]eoÔX?t`zŽøgÅo·9’dßðžÚÀT- Sþ65#wI»)šSÑ®²7Цº 0µmO„D!FÛÓÊÒVÎ;¿üòêËèeí/‰ ÛaºõÊ'iºóTsöA¶/4¦riĘÂ[°³G•Ü=ü®vî2{£Æú¡›ÓsÄï8+~gïzQTŒå‰I½Ôš±HºÜüéÍQ.œŠv•½.šAèÀMÛ±mTÖà-’ñeSµrW.Ùî5³1‚èC S¿ñ¥dïàË—÷SÀ³â·ôOK£¸ji4»ßŒ)%–NE»ÊÞ¨±~èÀÏ¿aºóÛ•eU#þTô˜ÔKÆ$®hd;‘›§\íÜeöFÑôC7¦fç·°ïÆBö'°â’µ®wgwyƒÀöަ%ñÛžèˆ90 ÏL³â·È"¹³\Š…íIµ4šöLoÏïdtòîáw*ÚUöFõC7¦çˆß0ïù®ÞDJPxåÔKÆdô«É¶ê¹=Œ€àmä]doM?t`jv~§àž)EŸ.‹–Þ-ž}ÎŒmÈhE :šîóÑ–) önåOö1Á¬øí7dý©’ æâJJµ4bLWé½Å’õFü†SÑ®²7j¬º 0=Gü†éÎï”%øíÅ\xåTKÆä–‚'cBIrÓüW;w™½Q4ýÐM€©Ùù²º·­»T…E?&EˆÌÆ|ˆÃÕ6Y4RdG'ˆâð'ÿ˜fÅïäÛYÛwI6YS¹4bLñ›1ù ËM¥¯vöFõC7¦çˆß0Ýù­ˆý\›Cy%¥Zê?Í|³uÊ!ëÝu¸Ú¹Ëì¢é‡nLÍÎïdûOÛOƒ[¶äµ+)Æ=½ 9»í ØV0¯“÷¹ÚS¼©Lñd>LÓžßÎɶH‘KÏïriĘÂy‰×Þb$º«±ËÈ»ÌÞ¨±~è&Àôñ¦mOÜ·ÏH¬.ñ–Ký§å®;£Ho¶rxy™”Ù뢄îLØìüζÏÐìvÀÞ6°Ô.p ¼dð 2iZš’â\-øÐ7 cÏ”_Ί߾Q2Q£#RSµ4œöL×ìBÛtÝø1žŠv•½QcýÐ=€ Ÿ#~ã¬øÍ`{u´Çëq¶ü³] \0&£Âz1&Ÿ·tS4§¢]eoM?t`jv~+’_qÈ5F^Ò˜ŒôøÛGnŽŸTû‡ /s ¶÷E7ŸdL8+~»Ê9gdæBü®–“x0à{va¾½(ާ¢]eoÔX?t`zŽø³â·ßš >Ç:âwµ4`L’ðr@”»ý?žŠv•½Q4ýÐM€©ÙùmsîgH\n[˜Äk˜¢9)°â2çaÆÔÄÛÆ³ÑL?Äü 0MÛžØS%%Ãj¿ºÿ˜ª¥c‚WÓ!¦YEÜ1¦ËˤÌÞ¨±~è&ÀôñgÅo %o.ó©­ESµ4`L””/Ƨi|£hNE»ÊÞ(š~è&ÀÔìüŽA}A†Œ‡Ëð409ij‹ýÉhÿ5&•h[A¿»¶—üà0‚óã×XJÑÇìY}P–âw¹4ð•·í›11§»»í2{£Æú¡›ÓsÄoœ¿EÀ½ï“’ËÕ?OåÊ¥c‚L×ÓÃéUÝ(šSÑ®²7Цº 05;¿cô+â‰ý`n11ú$^c Ñ@ M(f÷cr ׊à£WRpZü&Û”ŠýRâÝm?Åïri0‰Ç[á/Æ„§Ó@£Æ.E»ÌÞ¨±~è&ÀôñgÅorÏ·ï)NåÊ¥c‚ß“›t·‹†NE»Ê^Í t`¢fç·1Ÿ èW°‚¨¬1&c†ý"oà¼È˜bðnèm9)/îþä_ÍŠß!‘· !’rA½4`L”Ò{ÚsÌù¦ó›NE»ÊÞ¨±~èÀDÏ¿iVü¶*õqµ`LÕÒˆ1á7c²mÈMÑÀW;{£hú¡›S³ó;2X‰áaӰƘ!Ø~,Hf„5`:Ô-æàôØóÿ“À4)~g¿¶oäѶ´Õ0‚jiÀ˜"¼uLVñ›ð«½QcýÐM€é9â7ÍŠß(˜ÈU¿àó8 ÆT,õŸfhûŽëi¶Ÿ¸&újgoM?t`j{~û|nß„úXó¼¨1 C¢î÷Êð¾æ3U4Ç=W÷56þêsR†²ûo€iVüv€ äwdŒÍ[¹ri8»ðí’j©Üž+gù¾ÚÙ5Öݘž#~Ó¬øMn'f<ÖØNÑ•[/õŸfï§»=ËðFc¢SÑ®²7Цº 05;¿ýþ,åc^|9¯0¦€ÑØ^Î’Ð"cŠˆÞ{hO}Ù_~ ˜¦=¿ÝÛÔïÿe Òó»\0¦àº]`^¼¦ËÈ»ÌÞ¨±~è&Àôñ›fÅoÿ¶kö}ƒ_Eÿ LåÒ€1IÊ—ÆBpW4§¢]eoM?t`j¼ã:à`‘1qÈö—rvÖRZfLöøV·‘áOþ 0ÍŠßäÝAny€ wji4»0ñ÷ìÂÓÒ¼QcúÕÎÞ¨±~è&Àôñ›¦;¿“¦ +åV®Z0&Îr ùd´›£\¾Ú¹ËìuÑ B÷&nv~»,zÆ´x*‡®KåGÇ_XÖ˜ –‚k&N™øƒÀÄÓžßíÝ0º›âwµ4˜]Hú~?Øö]w5vy—Ù5Öݘø9â7OÛžØW ©ú³zo±4`Lß]¹`U{£1ñåeRfoM?t`jv~ûþ-yhH‡L´À˜"²û%c[k –~*ö„ˆDzûo€iÚö$A`É>0 ©Z0&ÌøÖ˜0ñ câËˤÌÞ¨±~è&Àôñ›gÅoÖàO!ô™íʼnIµ4`Lèê18½ªEs*ÚUöFÑôC7¦vç·w9Úc8û4\êü6l¡h,Qòhά,ú˜ÄoÿúT4,ÿ¤ƒ%O‹ß1jVö>!.,«¥Ñ´g~øE¥¹€/E»ÌÞ¨±~è&Àôñ›gÅo6ºol$EWn½4`L1âå`iÏkº{šÉW;{£hú¡›ÓMç·ßqP·ø±Õ¢øMÉžá ä_—EÆ”3¹½¤Šu°äIñÛÀ9gõ‰ÄRÝ.¨–FÓž“|O{NtãÇÄ髽QcýÐM€é9â7OŠßI%‰°ûáti_.õŸf /—ƒ1E¸›`Áù«½Q4ýÐM€©ÝùãM¿·9-2&†žüÂEζ·X¿Ã_2£Á!Ë”xÉÓžßI‘ÝT˯}S¹4`L1Æ7cŠ)Þ4Xòeä]foÔX?t`zŽøÍ³â·‡ˆÞ½‘µœ+W-õŸfà—ói•å˜äT´«ìuÑ B÷&iv~ûI=ø0]Âã’µ®£ÙÜ9½…Ñó;ùìdzý¨QœLŠß9¨÷¹=¤baß\-Ów¯œ½Lnä‰_íìë‡îLòñ[¦;¿%K`a Zn媥cò‹çÓ,Ú>æÆ]@®vî2{£hú¡›S³ó[#`@¿ã ÆmOŒnF´& 9­ ¼<õál/ÏÁ°ñ“î2m{¢‰mr1‰§^L{V¡÷©\x£1ÉåeRfoÔX?t`zŽø-³â·•—mÖí›_åÖKÆ„)½S tL§¢]eoM?t`jv~ß¡ ~˜èçy‘1Ïê²÷–èÖq…LÝ4E"Âð'ÿ˜¦Åoo[T5Ú›C9%¥\0&¿fsÖ¹yÒM]Šv™½QcýÐM€é9â·LÛžd´¯Ù³Ù'Yÿl(—Œ ¾§¤D wžßry™”ÙEÓݘšß™íáŽR šqÑóÛ7†ÄîôC^J÷²)R{›rp:üè\9™íü¶-å1ÁÝ ©Z0&÷9kÌÛ)î~g;w•½QcýÐM€é9â·LÛž€-¸Ó"äT´ TKÆäÈ‹11Þ¹ ÈåeRfoM?t`jv~Ûö3¦”]½æV§¤Pnš® Qe•12.!ÀOŽo’Iñ;{tf·[ös€ŸS¹4`Lîbz1&÷Ù¹©1ýjgoÔX?t`zŽø-óßl‡ä§bLåÒ`‚…êûhÛ}Wo„Éônç.²×E3ݘR³óû˜R†A}.À«!~i®ÛfÌx¢º õ‹_ŒÉè¥wXJNŸx™¦^Úž4RVã¼Tö1•Kƾûº ˜ø˜Ò5ŲÌÞ¨±~èÀ”ž#~§Iñ[m{”gVw§þQ4õÒ`‚…mùóŘ0òÍþ?½í:{£hú¡›S³ó;cTÀàç$¹Ó¬ø-~oÏÌm½t(—³ mk|u~“[ÕÝÔØ©hWÙ5Öݘž#~§Yñ;*#!ŒîÝWœÊ•KÆdîÕsãÏ뛓t*ÚUöFÑôC7¦fçwvµü–2¤UI4Äp¨ßaA91¦àjj8Ž?¹•KÓâ·f@¿Xä—‹K`*–FÓž#_sö(¤[`ºí2{£Æú¡›ÓsÄï4=ð’­üÝ6=&ÕÒ€1ùöábL‘ïî1¥kŠe™½Q4ýÐM€©Ùùm[91,u¥Éöt ¤çŘ8&{p'#]¶[dL ÈoÅ÷ü˜fÅïœ)Sv§8•«–FÓž3]'¿¨á®ó;Šv•½QcýÐM€é9âwš¶=ÉDâý|ÑÇül(—Œ‰²¼SºqL——I™½Q4ýÐM€©ÙùÕÍZ])’œ–5&ŠŒÆ•#-‰ßá/)ŠfI>+÷£ŒiÚó[@¢¬öç”/Ë¥c~ûSy9ÜÕØeä]foÔX?t`zŽøfÅo1ƯœÜï(•ÃÊ¥cBÖ뮜¦×©ÖE“ÃW;{]4ƒÐ=€)·;¿õ@؃؞À«ŒÉíÂ} “Ÿ¯Å¥vP$Ä£ñ;cø$cÊÓâ·ýnÛžŒùSRª¥cr'·‹1ÙëntÌ|)ÚeöFõC÷¦üñ;Ïv~J°}RÊÆýîÿë¥c†ËÉÃë7Šæl箲7Цº 0µ;¿ Z¼•É`âØ.1¦œÜP+øÌJ„¸8WÎe\÷SC<.X|˜fÅoÛ(‰”¤lÛ¯ŸÀT-¦=sºn ÃÝí‚|*ÚUöFõC7¦çˆßyVü Iìá곂 ©Z0&ûX¯{Lö¬~Ùì6ŠæT´«ì¢é‡nLÍÎo5¾#nøF˜;¿Ý‹)¾”ñÅ VÜŒo‰(dPäO^IÉÓâ·ø®ÖEy­<¿Ë¥Á$‰ùª1D? iÓ¥h—Ù5Öݘž#~çiñ;ûè+eû@Jñ»\0¦oËägQ7Àt)ÚeöFÑôC7¦¶ç·{Ž$MQüDq8Dé'c¨Þâì“N, ÖSf7H·}5ˆ@øäÀË<+~K`§ÐVR2¦jiÀ˜(|O{ŽzgF˜OE»ÊÞ¨±~è&Àôñ;ÏŠß|2"ø?ÅËzi0Wäðc&?ÚY}žëk ìëÿ‚)ž.å?>jÐþçYïŒp®§Ìð¼,ıº“Íù3Š^yòûÅwF<×í¥>©6_¯÷S%÷:`¸ý;f}g¤wF:3>Ú£ïýú?û¡½ ŒäÊM¯¿þø>Fö¶à׳þõ3¢Ú–â˜?†õ_ Á‘’ðTÇáïcäcNžoοZ(ç ‡©ký>ú+”™_¿£mj¿G<ך¡Š¤ëoô^Dõ¿[nÿj—pþÕöž¿3Òõm3iÔK¿3ÚH8ÝWæïÏúõ;âÞGȉ¾ÿjû£§SB¨þ‰ö7Ä×_cÌ‘Þßïã1Ö3¥ïŒÅʇéö}„Óë·µßä;ãõ>"'²/}ÿÕ(ÑwÇéö}ô9îWõÈ÷_}Õ£_*J9§ïzŒÎÌëmF{Aº2Æ!§?¼d¯7|ÿÕnVä°ª3úû,¢r~2ñüÒÞGï0!¥pfôßQ¼†Ï>—Æïh{â3c8ë‘þôý½vK üÃûèCïíÝu¡µþj²7òO?«‡þô]Äb!¤@3Ÿ ÈÒþ«_ï~£^ þïíêÈÿ?ÿý¯þ‡s¿ð×üÓ¿œÌãþö×ú§þ‡¿þ뿤ÿýoÿéOùþö_ÿíø‡ÿ•þüŸÿþZþ‡ã9øþÏ¿4¾ûÇ?ÿîý¿üa<ƒíIü_ÿáþú_þé¿þË¿üÇc¼~^üó¿þã_ÿþþ»z3óý`zýzÿì¿ßõ÷ü—¿ý«ýòöûû_ÿ¿ÿõ¯ÿúÿÇŸþÓßþñ¯úë¿þÇÿå_þúg²×íß_yþþ××#ôúáÿdOÖ¿ýýÿ~~|>Å‘ƒÏÿAQþG{äà8øÐ ÍŽ‰gñ ƒ¼?Ü|ÃwpÒ"8”Áøÿ8 dxgöH?HÆÿËþÿó¿Ú³ÜÄyüßÿêËyѵh,9ª{ ûh«¡óÝýÿÛüûñÖ^¯ú—¿ýí?_Ÿö騧ýïzó=;^÷M}*f/ ‰Q‘r´xUÀ÷e¡ri0#9eÂãýøó»¬+êëÄ竽¤¾ÃÐöKz‘Í?•û% Ķ[Ià3EV:¤öj{¾;Ðú8n¡e!Çàœ¼Ù“†ôBÎõñ kŒí!«ÎÃÜF”à5ÖXˆ…9j8kŒÝhý»~ÔØqðÛÈÞ¨±~èBΓÿ=ƒà¢™<“7Rcßx#"²†4ÕÒ hDޱWþ;bBÉ7EC_íì¢é‡nLÍ3y?ùwÂÈànr+Àä/ö6߉’0.}!RB£Üê=ŒAFEó`š=“§ã€À~-ß‚ý¬±j©ÿðóñÁ—h}äæMíUöFõC7¦§œÉ_ï÷¸hröËñü>4]ŒÕÒhªd8†8„Ã÷Á¶Ó7Es´WÙEÓݘšgòJ‰ìá›Å/9ÅEƤä³êÄþS)Ó’ÂlC&C&)‡ðbL¦Ù3y¿/ àfß”Šöêji4Š$‡—\ÿg?=ÄVíUöFõC7¦§œÉ_ï÷¸h2E6ÎöJE#G½4¢Ùùè1<SÆ[š}Y¬•ÙEÓݘÚgòèø,¡Aêx HqïÅ«cö™"°àÊ} qffP‘¬øI`š=“Ïh)ñ ¼Tú×VK#›ÈWƒÐñ+Ñ0íUöFõC7¦§œÉ_ï÷¸h2¦€Ä$è&ó?©Z¯z/ÀŘ²Æ›¢‰á«½.šAèÀÛgò`¤1ÐÁ^hÙ&ÜA…ˆ•Æ·ð Æ„jß2Nl;HÁaÑü˜âì¾±>õP‹©õÒ¨½ZÏcVCà`{å›;Ïå«ìë‡îLñ¿o¡ýGÑL»±aˆ˜³ ÆT. :ÌüŽæÅ˜‰Ù­¢¹,ÖÊì¢é‡nLM76¿ ²7í0SZЯ{Ñï£q²m Z¯iL`Ȥ@¶T|ÌÓì…4ÿSì½ð‰²±°‰¬–rAæ7c‚bº©±ó–Y•½QcýÐM€é9âwœžÃ͘l“ä7§Žf?S¹4`LD/Ƥ)Ý=Í®áÚeöFÑôC7¦¦ø †)âXê~‘¸(~áwÇÌ>|Qc êL)åÊ1|r+gÅoû°m8QªS¹40Ö²ÍÖ¥1ALpsÀù«½QcýÐM€é9âwœ¾–ìûC’ûΘʥcrñðü) ÜˆßñºeVfoM?t`j_Hã½#Á~gÅÓþ×îh8,*šEVöG{µ½ŒÄÑ;wÞǤ·/þ 0M" r´zS PŽ")—FÒ„/ÏM€[3^óEÊìë‡nLÏ¿ãü(’_‘Ê›²åÒ¨…ß^p2&ŠáèƒkÍ{¾H‘½Q4ýÐM€©)~ƒóis ’Ò’±öñbõÓ!9zχ·½Þ®!}Õ>Ù.gÅo{®@4x>ŒSµ4h`8ç’ûžUõŽ1éW;{£Æú¡›ÓsÄï8-~{OxvsŠIÕÒ€1qÆkç@QÃÆ—¢]f¯‹fº0ASüvu mc“(."ñƒëßö¢¿~‘1%£«öYH2„z“Þ¾øÀÓnlöLÁLêMYcª–'¿‡®tjL(wr\keöFõC÷&xŽø Ónl€>²9‚}‹ ©Z0&—U.Æ9ÜœÊÁe±VfoM?t`jŠß~žFj¤â˜x»Ø.`/ö‹ƒ>J,°.m厫D¶ƒK ÇðOnå`ÚÍ>?¿éÅRˆßÕÒ Æ qó¥1‘[h¶kì²X+³7j¬º 0=Gü†iñ;Ù)û,ªú˜Ê¥cʘãŘl¿~ǘ.E»ÌÞ(š~è&ÀÔEÂ~—„S²ïN~Í´[`LöbcÛÐm‰ãÒVÎ×bI˜³%ø(cš¿}²†äÞ0¥ø]. Ú8ÓåJ”ñ˜.E»ÌÞ¨±~è&Àôñ¦Åo{LèËí¼ ÙõÒài¦ oÆt:´ŠæR´Ëì¢é‡nLÍQ$âð` Ϩ«ß¤YcLöbÛ‡q6p“( ÕÁ˜ ¥O×ó.ú‡€iºóÛ6µ!‰ñ¿Zc*— –~r1&6VzScW;w™½QcýÐM€é9â7ÌŠßh<ÄÐVÅ$Å©\µ4j~Ë|õ1‘‘œ»¢9í*{£hú¡›Ss‰økNGcÊKÀt¼˜¼KREõeڿ˜Œ·ªýtÙ~ôI`šžÃ Ÿcp“ÒX»ZL•ˆQ/—rÛrá\p ×.³7j¬º 0=Gü†Yñû(bô½A¡1UK#7öpZ»8å&ávÑà©hWÙ뢄îLØ¿ƒÕ4Î’³Q&Ã襭ÜñbñqÉÀe•1ùA*Ú+Ãå¬ó`ÂYñÛŠ!PÚjaÞ^/ Nå ²ñbLn¿pSc§¢]eoÔX?t`Âçˆß8+~§Èšs ‚1UK£ù5¯Óiû”é®hNE»ÊÞ(š~è&ÀÔ´=Ñà£Û²;yÅ ·JŽK¼öñ¾¸qÞé?µÂ˜À¾¼>³%ä )~˜¦;¿#ûL Y°ìü.—ú5¦"á}*g€WcW;w™½QcýÐM€é9â7N‹ßÞ»Á€‚¹œøW- ]WR ¤òÍV/E»ÌÞ(š~è&ÀÔìü¶]X°MØ·Çåï5Æd/!&§¡‹ŒÉoÊÛнÍÃGïÊá´øÍîe Möˆ)€©\x$n\:&øÊ›»í2{£Æú¡›ÓsÄoœ¿‘ÙÖÚ¾? cíjitbóõ;’Üö1á©hWÙEÓݘÚßÞ@¬~3ǯ8,»=^ýN ‘Á1¥ùŒ)B¶=N¶Ž&ù¤í N‹ß!¸aW%~—Kƒ+)pÅùŒ¤×Á~«Æ.E»ÌÞ¨±~è&Àôñ§;¿“;(kð{¿eçw¹4`L‚|9X’=³ïÓÕÎ]foM?t`jÛžølGAÉâÀ´:îÖ^ì·Q€ÝÖj ˜üÅ>®Ã¾¿@Ÿ<•ÃYñÛ¸HT7twç'0UKÆ„×}L°×Ý1¦SÑ®²7j¬º 0=GüÆéÎoæ•¢¢”Sµ4`L Þ§Óöm¼»`IW;w™½.šAèÀDmÛ“ÈIÀûÝ#7/2&?ƒd äsLtÕ^ãnr¶oš ¿e&š¶=Ì Õ¯i1#©Z0&Jïï{XÝÔØåeRfoÔX?t`¢çˆß4+~sòÎ~LÆú¹`LÕÒ€1åHï>¦lߎ›¢9í*{£hú¡›S³ó;FͽŸŒr’¥I¯3Å䃴ƒ. š¦éCæ&šÃÿ˜æçpû‘)R.5¦jiÀ˜8‡·ç—mZoX9½‡kÙ5Öݘž#~Ó¬øè[ És®ú˜Š¥c²¯Ä›1ÙFæfÿOôÕÎÞ(š~è&ÀÔìü¶ïŒí@³Â¥©’¯ۮ‡=…,ÃÁ?“Ï¡T{øûÔ[ Ã}ào€iZüVQŽbeQv~—KÆdoèÕš…¶]½cL—¢]foÔX?t`zŽøMÓߌè6b(,«¥AWn½öÿ¤H7,éjç.³7Цº 05;¿#dCRÒƒ}–æp¿^ìÈî÷JcZdLÙO|’[´7î“À4-~GQJ„0s¸«¥cÊ(oÆr7ð‚.E»ÌÞ¨±~è&Àôñ›fÅoÊÆüɧn§rÕRÿiÆö8»Ü ¤ÂÍ>í*{£hú¡›S³ó;¢±wüf ¤Î#¹ -Ð-gL¶ D'èSøòGÓtç·øà€ä2ýlâ­—ŒI\½rè†è75vµs—Ù5Öݘž#~Ó´øm{k±­’m;Š›ßõÒ€1ËÕùíãoŒâøR´ËìuÑ B÷&nv~GdÌ9A`«²asˆ"/ôŒ)œ%¥€~“÷“Œ‰§mOÈ/2'ã” ñ»ZXë†ü¾‰îì›ùò2)³7j¬º0ñsÄožîü=Ž$çÒ©Z0&·Mº“»ÊÞÍÕÎ]foM?t`jv~GLVâÞçˆHcx(“kj†i`4qE rÆ”¼K!d㘶óôI`š¿í‘åóÚƒ_þ+Sµ4ðcò¡×c¢Äw¿SÑ®²7j¬º 0=GüæYñÛOPì9d{ìÂ] Z0&Æ/ÆñNüfújgoM?t`jv~GÔ˜5;롆ðP2&…Èn|’×5¦d?9HÊNZY>y*ÇÓâ7yôÉ\Žo*—Œ !…‹11ÞMâáKÑ.³7j¬º 0=GüæYñ;‚€;l@HX0¦jiÀ˜ ™ÞS¼ícâSÑ®²7Цº 0µ;¿ l#g›O²‚q‘1‘«ßö·w€`ax0&±bЦš|ß'iVü?!´ÎÏJwriÀ˜Hãuò‹"·Àt*ÚUöFõC7¦çˆß•ÓÈ7:¦\íÜeöFõC7¦çˆß2+~[‹õ}RÊ?rë¥þÓL"çËþ‡½]í¦hNE»ÊÞ(š~è&ÀÔîü6L@ß‚&öoËS4þ‡u|â_0&ÛAŸ®ê ×'iVüÎö×ø«~óïçV®\LâïV}ÕÒ»Ó¯vöFõC7¦çˆß2+~% Ì> §xšÕKÆ!¿û˜(æ›­\:í*{]4ƒÐ=€)Ýt~+ÙÆÈЪ“½XÕþ#Ÿ+´È˜€íÕÆ˜82} ~LiVü¶mRpƒaŸñ^º ”K£¹r—[ð1í9Üè˜)~µ³7j¬º0¥çˆßiZüöÓw¶!c<…ø]. °¼û˜HãÍþ?]Šv™½Q4ýÐM€é¦ó;{æd4o府/6L1Jİè`É“÷AúU½OÞ•KÓ¶'h11H9%¥Z0&ú®1rá›»¼LÊìë‡nLϿӴøm>Æh_zÔÒÁ²\0& ü¾+GÊ7íéR´Ëì¢é‡nL7ßb¿rqŒ—“¿ïæ¨iéJJ8¬°X¢&©OÓ¬ø}¼Bȱ ê¥c2Þ|¹ ܳrþjgoÔX?t`zŽøfÅo7ˆÔd\¤èÊ­—Œ‰HÞ}LœôFüN§¢]eoM?t`jw~ãáÚíy£®¬Áùbã;Ñ6u¸x*G‰"øàh4à“À4+~gÿ¾‹¸å¯”~LåÒ€1q¦k¸0¹îMŠv•½QcýÐM€é9âwš¶=ñ÷1ÛƒâeZúÇ­\¹4`Là͘ävàeº¼LÊì¢é‡nLíÎo4B¡A}pe^1€óÅh‘£Ú/žÊú¬+ƒ¤h¿Á'iVüfûÚgR¥¡ðü®–Œ)¾5&Èùn+w*ÚUöFõC7¦çˆßiºó;‰ks-£4Š«–Œ)Áû“Ë7À”¯vî2{]4ƒÐ=€)·;¿!ù™šÁCvçîUË€0Ûc|â_0¦hÄÒ/¥Š_Jùdƒežïü–äcÜs²ÜÊ•KÆdÛú·K*ÂÝÃ/¿Û¹‹ìë‡îLù9âwžxéæM€Â¹ôcª–Œ)„‹1¥t7Z'¿§XÙEÓݘÚß ~%0„WZ‘à|1ù!dVÅ—9/7Ô®™N1 !ñ7À4+~«‘+ñ[2Œ%0UKƤÂoÉpä¦] ŸŠv•½QcýÐM€é9âwž¿!+f ‚î‚õÒˆ1å÷\9N¾ÚÙEÓݘn<¿Y}v¢Áiä•Ýœ/&w´æ€ˆKíN*$¹7]ò{©ù“[¹<+~³Ê1KRIª­\¹4ð•ð¾]@òŽ™OE»ÊÞ¨±~è&Àôñ;O{~GN>Sœ–ü¦jiÀ˜4ÄüfLùn´N¾Œ¼Ëì¢é‡nL7žß`›1ðNGÊyÕÉ^œŒ#bÄyñ®œñJEF`r{ÝO6XæYñ[íWI)˜R,îÊUKƒI<1ËÅʉ_¦q­;í*{£Æú¡›ÓsÄïLÓßÉv¤É\/›·?v~—KÃiÏáò•§¬wÖ:zµs—Ù5Öݘž#~ëtçw䔂ý— —¶'åÒˆ1!¼ïÊÙWê¦ùM髽Q4ýÐM€©Ýù•¹ùKÃCÁ˜l#w°%Û EXdLÀöFÄxœ ~˜¦=¿#úÖ4—¬¼^0¦¤ùòc¢Ó¥Uc—‘w™½QcýÐM€é9â·Nw~gvIB|FRÙù].S–kJ*Ë­µ®^íÜeöFÑôC7¦vçwdaA«w9üóÖ“½ØO¢7½/2&{Yðù(`ÛßÚžè¤øm[R¢l@–Ba­[/ SŽoVN9󵮦¯vöFõC7¦çˆß:+~s@òé#Â\Üü®—F§rïS9ûNÞ=ÍNE»ÊÞ(š~è&ÀÔîüŽä”nŠ«~LÑϬ5:'5£¸ðÐlc‚â×7>j{¢Ó/sÔh»Zû¥˜Ä[- “bzŸÊùPï›»¦X–Ù5Öݘž#~ë´íIÄ㊋8å%Þr©ÿ4K1à÷©\¼ñüŽáò2)³WE3 ݘbýѽ“7]%Žh¬ú1E·S$vËïÊù ;"r(òþÓùñŒk,‰al?P.©\0&~1&{EûT.†«»ÌÞ¨±~èÀÃcÄïóýMöa?fLR´ TKý§Y‚×aþÙùیɾ¦_íì¢é‡nLíÎïhoFÊnxÍZ÷x±wgÚþ"FgžkŒ)"¦dŒI?8ðòüxÆ5fÏ“”3ØsÅ8N!~WK_yÃì·Kªþ0Šv•½QcýÐM€é1â÷ù~‹Æ½×ì;ÄG+~9¾©\0&ŒßŒ)ÜÍ©hWÙEÓݘÚß> @‘Ä”hu¯½8Û7ÅOÒøVIÁ˜XsÈà]‰Ç翦iñ[ühRÙ1¡t(—¾ò‘¾{å‹¡·jìR´Ëìë‡nL¿Ï÷{\4~ps÷Ù€©¦biÀ˜0¤÷Ó,å/ËøÕÎÞ(š~è&ÀÔîüv_»˜mêcRVOå‚m,$ûØáê`LîI`{AÃ&”ñE»ßÓlç7V&LjÛñâÚS½4`Lð2‡{1¦|sÓ€ý«½QcýÐM€é1â÷ù~‹&{>ˆf±'&ÕÒ€1ÑÜ2Ý“F}¾ÚÙEÓݘÚß> ;¨o?}–Ò*cbÛˆ!¹=€Ê’Qœ«µ/¯ñU!ãôÑ­ÜôÀKô.!«‰ \LI©–Œ }ÖYcFÐïjìšbYfoÔX?t`zŒø}¾ßã¢ÉˆdOewŸŒeƒeµ4`Láí.óÍhOE»Ê^Í t`ŠíÎï5â}Ž«Œ ‚ `±ÝÊ¢ƒ%€Q4ïE…I?)~ÇYñ›SðQ7Q CåÇT, æ·ƒ¥áþ}sŒñ«½QcýÐ=€)>Gü޳â·;&R÷p-5¦jiÀ˜óÕ•k›õ;a2žŠv•½Q4ýÐM€©Ùù­Á/÷G±Ç08<ÜTC‹1©Ÿù\ôœÕ²Ì¿ø`LÞÅìcÉÝmnìËû`šxIQÐ}ˆª))åÒˆ1)¿k,0ÝhLñšbYfoÔX?t`zŽø§mOÈžËêàro¹4`L)\O3MÚn~‹ñò2)³7Цº 05;¿ [C´(:@¬ÓñbÍ!ù8=•ŒÉ[¨gÍötO2ø 0ÍŠßÆlÀþÀiÉO`ª–ŒÉPþêüæè]ñí;í*{£Æú¡›ÓsÄï8+~3G£$I2Sµ4bLô}*§¯þÙVÑœŠv•½Q4ýÐM€©Ùù­I’íåôÈS…ì¦ 1YeLŒZÚ“Á^ñ£[¹é—•Òîì–Ê»råÒ€1Ù~þ­cºçòM]S,Ëìë‡nLÏ¿ã´í‰=ÓÅMJƒäòT®\1¦×¥ÊcÒ[š}y™”ÙEÓݘšß~ºÃÂj¿¹B‹ŒI$ûvÌvctaèE}ªœ¸£“Û®|”1ÍŠß골HØ ”JÆT. “»j ´¯=Åx*ÚUöFõC7¦çˆßqºó;¸ÿšíֽ˸ИʥcJ¤ñ͘lÓ.¸Ú¹ËìuÑ B÷&hv~¶®°ø<&˜¿“ÆcoODúSǬ—öxz³rÊéFÇ„SÑ®²7j¬º 0=Gü†Iñ;)2³7c+r«¥c£ÃoÆî.ñ‚|µ³7Цº 05;¿Õç )C4šçîökŒÉ8¢Ø_ížeKâ÷KÇÍÙ÷s~éù£À4-~£ýFMD…µn½4šöœ¿O~…cÛW>Â¥h—Ù5Öݘž#~ÃôÀËœ»è>¶µècª–Œ‰I¾,åf´N„kŠe™½Q4ýÐM€©Ùù­`{[Â(–Oåø µJKíΘb–rb¦0±ò`š¿Ý¸܇ÜI±•«–FÓž%~×XŽw¿SÑ®²7j¬º 0=Gü†IñÛ X‚Ø—ž4wåê¥c¢$ïÎ7så#†¯vöºh¡{Þt~û•HF^pižœ/Uö¡rƺÖ:¿c°§¾%0¾5¾¥÷ `ÂiÛ«Œ4©‘ÈÒö¤\0¦Dá]cÆ oN~ñò2)³7j¬º0ásÄoœ¿Ýì!¸ªL>‹¬ ÙåÒÈ]ðí`éoоÚÙEÓݘڞßÁ@)8Ñ‹ÇíœÅ»rÑÇ̶ºÄEKcL ‡áŠØ»öÉ­NÛž÷‰Ä›ªËS¹ji4‰‡9Ÿ5&õæJ ^^&eöFõC7¦çˆß8+~Û#Y3©m8íÕÒÐ ß7¿ñÖ+OE»ÊÞ(š~è&ÀÔöü¶ßŸA€Œëå´Î˜‚Ï«fÛŽ .Ε‹ÂÞ.è.ÖãI¿¦yÛ“|­G¨lOŠ¥¡Kj¾îʉÁ÷]½½LŠìë‡nLÏ¿q¶óÛŸ®öqÑ0UKÆè=Á‚cºßñl箲7Цº 0µ=¿ƒßâÅðö½êù|$œOí°«žßQ콇Žkza¸ü 0MÛž¤¨ ½"`á.P-jLÒuòkãùñò2)³7j¬º 0=GüÆiÛ¿¹`ûj·ÿ)€©Z0¦ÀòfLöä¹Ó˜./“2{£hú¡›S»ó;«#ƒhʪyµó;«Sv·=²-ì⩜} >WV$’Ò §=¿}&>„bq*W-jìu åŘˆn,ñ2ò.³7j¬º 0=GüÆÙÎoA‘}œb9%¥\íÿ³êج€nNLèl箲×E3ݘ¨ÝùÍjŸýÖÞ'¹b¯£½Ø6rQ—®¤c"ÁG¬S›0sú0ÑôÀËàæA3†rAµ4ª±×Û×í‚È7[9º¦X–Ù5Öݘè9â7Íw~ÛjØ“ª­\µ4zšIx÷1ÅÀwÀônç.²7Цº 0µ;¿)‡¤jUŽúê¿^aL”!e6Ú„IV^|0&{›BŠ1úX::Aý˜¦^‡éœ|V^ÙÇT.4¦,o—ÔÃD¯]c×Ë2{£Æú¡›ÓsÄošx™€¿f˜Ê+)åÒhÿŸÓ·ó}Ñ\S,Ëì¢é‡nLíÎot Ö$Ç ¦EÆ„>ŠÀ§]Ú¾,.]I1Æd\ cV¬nÛÁOÓtçwrc)TȜʓßriĘ(]ßÛéêÍVŽ®vî2{£Æú¡›ÓsÄoš¿£º1µ;–Äð³ù­^0¦ò÷‹Lá¦hNE»ÊÞ(š~è&ÀÔîüF†œ LSä ·JàõbÊ“=^È(Â"cB! #eþ˜^º'.dÿÖÿ¬±jiÄÊ_ Ћ1%¾Ñ1é{ŠåÏìë‡nLÏ¿iVüVŸ~fì_K?¦jiô4ƒxýŽ÷ã›íûòÕÎÞ(š~è&ÀÔîüŽÇL9{£{o/2&ßY%Ê/™h‰1ù\#L>Ú.@³â·±R{A2BRú1•K£ÃüîüN|w»€ô«½QcýÐM€é9â7ÍŠßчXg¿¿˜©œ+W.„oÆ„w}L¾ÚÙ뢄îLÜìüöý[rG5ö’–¶rÇ‹mç$‡ä>A‹Œ RôkJOµ=áéÎ©w£· ª¥cB}ß•Ë!ßÕØÕÎ]foÔX?t`âçˆß<+~£Ï=s»c(çÊ•K#Iñ{JjÖ‰OE»ÊÞ(š~è&ÀÔöü¶½¬§.KֺNjÅG;]"YõüŽm çîBÌøÑ­OŠß9†€ö…·]f9‰§\ÕXüÖ11Ýô11~µ³7j¬º 0=GüæYñ[PT£øÙ×Ï¢©–F'&À—Wù'|S4ôÕÎÞ(š~è&ÀÔöüv£7·°ÌÄ>þl1b rƒä ºê.`_݀ј…t|ò/ÏŠßdŒ¼­š°´=©–†½ré͘ß>üNE»ÊÞ¨±~è&Àôñ›gÅoûÞ m¯1#U§råÒàiáý;Ž7Es*ÚUöFÑôC7¦fçwöëê •1󢯔Ýß8Sr‘*¬º Ä`ƒrðÞìOÅñ¬ø1)J:))XÊ¥¡ÆÄoÆ$p7T•OE»ÊÞ¨±~è&Àôñ›§mOährk-,«¥cR‰oÆ„wG¹|y™”ÙEÓݘšßYƒW:¹·¯ú1Ù‹YÂáyâWrSÈ¢øU^{ø²]€§;¿}2` ì¿ËÎïri¤câÙ.ÐgLW;w™½QcýÐM€é9â7/ˆßjX·¢á‚1UK£§™ÀuWŽR¾&å[Ñþ™½.šAèÀ$ÍÎïœç6 j6ê³È˜rPIÇD«§rnÄ ÅÞ´$ŸÔ˜dVü¶Š7Œ&ÛšrÑù]-X¹†Ë]€Sºx)§¢]eoÔX?t`’çˆß2+~?šÁo¤–õÒˆ1½úJÆäˆnŠæT´«ì¢é‡nLÍÎ?Ý} nJ«wåìÅnk¨„+ûÀcòùM”ÁüØšà7À4ÛùÍb@ îZƒE¯\½4t°oÏo“›;Û¹«ìë‡nLÏ¿eºóÜR, ?ÚzåÔK#ÆäóOÆ$¯—´Šæjç.³7Цº 05;¿³J¤V倊KÃŽ eµK‹ßê÷äƒòKzãÿ˜¦^ÚŸcŸ\ AJÆT-Süƒƒå­ç—\S,Ëìë‡nLÏ¿eVüvk7ˆÔ¸œ+W. Sf€‹1ƒ [Es*ÚUöFÑôC7¦fçw6M’l;EÁϟדP$˜ŒÆ ¢ƤÇÐFñ B9Œ~L³¶'`í†ð¶A-mOª¥‘Ƥß÷1%݉ßrz™TÙ5Öݘž#~ˬøííâ6Ѷm(€©Zö˜¼§¤Rz]OiÍ©hWÙEÓݘšß™]äÁœŽn¤ÕS96–(QüÖÜ¢»@öq™¶ãy;ø7À4+~Û×Åÿ@üy%¥^žüÒÛóË{HojìT´«ìë‡nLÏ¿eVüNàs·À¦²Á²ZiLôžùå£C»hÒ©hWÙ뢄îL©Ùù2s>|7WOåŒí°‹þx‘1e>f6JV#8lÿ0¥éÎïc°ŸÕ–ßåÒ¨Æ"¿=¿Qõ¦Á2]íÜeöFõC÷¦ôñ;ÍŠßÑ>ޤäã«S¹riô4 ùòÊ¡s”s«h૽Q4ýÐM€©Ùù!¹ã‰$QÕ´èÇd/†Ém^#ñ‚r~0&Eñç=©ãÿ˜fÅoÃH@c¼œbÙ.P- O~õ=»^Wº[5v*ÚUöFõC7¦çˆßiVüv+‡sÑÇT- Oåà}*'ïŠæT´«ì¢é‡nLÍÎïCÂL‘ý÷_dLñ)mb€‹§r~=>2DU†\í7À4íùMöWä öïrAµ4Ò1ß÷1îšxÓeä]foÔX?t`zŽøfÅïÀ Ú·@QŠ{LÕÒHcJï¹rä—¼nŠæT´«ì¢é‡nLíÎoŒ~`Ÿ "`Uc7Ý—¤"­ ¥{1¦ˆö3EØoò|òT.ÍŠß‘”RbÛü•~LÕÒØóû{/ÜYë¦SÑ®²7j¬º 0=GüN³â7)س=dMJ…WNµ4<•“·ÆDInšßÒ©hWÙEÓݘÚßȶóý'!¯ÓñbcK‘BÀeUcÂÃû’9Ð2¦é—ä 9RV/Ë¥¡ç—\'¿L¯vÛVéW;{£Æú¡›ÓsÄï4íùÍlë VϹИª¥ÁþßO’.Æä#ÛE“/#ï2{]4ƒÐ=€)·;¿1:Œ}¿Î»È˜Œò8£ñNûg‘1‚&Kqœ|òT.ÏŠß~‹’1• ñ»Z1&”·¯¼cþMŠv•½QcýÐ=€)?GüÎÓßkN1—î‚åÒHcâpMI!ûJÞÍÕÎ]foM?t`jw~³{)‰_ò7Ò´Ô`ù:X }¸ºÇÕ¢Æ$Å6’`Œ ?)~çiÏo¿6h»q*j¬^1&¿ßs1¦p×+—/#ï2{£Æú¡›ÓsÄï<+~£¸A´ °=jSµ4`LɾFcB¾Ó˜ò©hWÙEÓݘÚßlà’Ý{=¨®Yë/>PÅÈ–%YtÈ‘û4‘|Û'iVü{¬:\õJÅV®Zü¦w¯ÜÑytSc§¢]eoÔX?t`zŽø§^"'·rÍ ¹¸’R-4¦(W‰±„[ÆtM±,³7Цº 0µ;¿ ˜çpÌXvð¹M”_˜kâ·‘ åcókd-Ñø'ÿ˜fÅoÛ˺yÄ¡^.“èwßÓ©hWÙ5Öݘž#~çiÛ«`²SR):¿«¥‘Æ$ñºùmÀt'~çËˤÌÞ(š~è&ÀÔîü&';A}PJ\öcò6€ã Ƥç'c:¡A¸Q¦Ÿ<•ËÓžßö $IîÊYlåÊ¥a¯½Ý Ýy~çËÈ»ÌÞ¨±~è&Àôñ;ÏŠß¶c?“¦(å•”jiÀ˜l+w¹ ºÀMW®žŠv•½.šAèÀ¤íÎo¢>©“BŽ+دfc>ICÆUÆDÞOÆîgÀôÉÎo¶=ÉBna_z-¶rÕÒðTî{J Ð݈0½¼LÊìë‡îLúñ[§Åoö¡ŒþåQ-¶rÕÒ1ñÛ]ôîæ·^Šv™½Q4ýÐM€©Ýùíþ>¶‹nŽ”Vý˜ÈàF¶(«¦¼ØÇ”ÐÕŸ ìÕãëÿ¦Yñ[ 5úÙPXëÔKûrr}Øvø7Ö:z*ÚUöFõC7¦çˆß:-~Çlã’„zA±4`Lò‡»rñu²U4—¢]foM?t`jw~KŒD)sŽŒk/GÛ¾ÚS\ãâ$^—aÈO…Э>L³â·oKyRR:XÔK#?¦ø=%ß±òSÑ®²7j¬º 0=GüÖiÛ“ ÌêC9¾©Z1¦×ìج‚nŠæò2)³7Цº 0µ;¿Qãmbwß\=•sÝ:b@Ÿx¹êÇ$)M;ØÖgiVüN¶©TÎc9Tµ^Ý•ÓoÏo÷¼©±SÑ®²7j¬º 0=GüÖiñ;{XøÃÙö…ø].4¦Ì×þŸ¢ÜÒìKÑ.³7Цº 0µ;¿IA‘­Ô3yçÄ¢Æd›Öè7Þü¾ÜÒ%^û8‚Fw§ƒˆñ“§r:m{¢ÎxÝ;/–/«¥á$Þwy³×Í©œ^^&eöFõC7¦çˆß:íùÍhÿÀñïBcª–F}Lù»óÛ«›Ecdù«½*šQèÀõG÷êc2¾dAJÑ jUcbôs5¿!,«Œ Äý"îdÉyxøßLçÇ3Qcö.PÖh[}ÑÒó«\ÞÇ|8¤Û‹_íìë‡nL#~Ÿï÷DÑøÍ}rØŸES- “Oö8Ÿfî¡nоÚÙEÓݘn:¿%pFÛ…ªû"®ö1‰²½Eƒ½Æ˜œ.‹½W ÅÊà“À4Ýù-Ùþí³Œ“”[¹biĘò·ƒexÕ[«Æ®vî2{£Æú¡›ÓcÄïóý_``ŠÙ13¿ª¥cH—Æ„zG³!œŠv•½Q4ýÐM€é¦ó›ÔþO «~LÌÁG ù€ÏÅ­œOÎ64 nã÷¾>Ø.p~<35–8'ûW¯_?ä‚biì`ùöü‚í“_üÕÎÞ¨±~è&Àôñû|¿'Š&‡ã&;ø5øBü®–ŒÉg.Æä½…7Es*ÚUöFÑôC7¦›ÎoÐ$F´í-3&ð ˇñ7­Î•3ªì>q`{ùà%Þóã×Xr$[ûµŠ¡ªõÒ¨‰èª1{Q¼«±KÑ.³7j¬º 0=Fü>ßïqÑdò²˜# 4»^0&R½ü˜1K¼£Ù——I™½Q4ýÐM€©Ýùí¸É]ÙbõT.“º­Gŵ­œŸ¢Û7Kœ^2†ñ‹L“âwö¶}µÕÅ«¥qç÷õ=°rãöɯ킿ÚÙ5Öݘ#~Ÿï÷¸hRRÍbü&†PN°¨–ŒÉ¾€—» ‘'½¦¾ÚÙ뢄îL±Ýù„ {sÌqŸf‘1%±½Z‚äýÈ‹Œ ½W RÊÁþë“Sœíüæd[qfäôòøã©\¹4`L¶C~ß•ƒ w5v¶sWÙ5ÖݘâsÄï8+~£µGEÊ1UWRÊ¥c é&11Ã͉I„¯vöFÑôC7¦›ÎoÉGQÊ)ЪÆDîmíl+Û–nq¯ïp³½Üþkü“LӞ߆±ª)1ºbö˜ª¥cò›>—ÆäWnjì2ò.³7j¬º 0=GüŽ /5ØÃ' &^õRÿiÆúšóu0&J7^9¿§XþÌÞ(š~è&ÀÔîüÔÃÝŽRšà-c²gþ$:žÀô³h(³ÚŽ£ØûöÉ»rçÇ3®±äŠcÆ„Çà˜ŸÀT- “ ûcŠ(7,ñl箲7j¬º 0=GüŽó¶'FHˆ€C‚²Á²\1&N×]9¤|3ŒâÛˤÈÞ(š~è&ÀÔìüNJ¾=°·ÄEâ¥+)Ç‹Hm·²èÇD Š!Fûñ!‡ÅÏDÅ"+¨{Ë•½råÒ€1ÙöííÇäwoj,}µ³7j¬º 0=GüŽÓ/ƒ=_1"Ù ¼Ä[. SÆ÷þ©m{ñšbYfoM?t`jw~»ã &û#ˆh|h_0&?è'{?}ëJKÀ䮯ÞT)Ø>ò£ŒiÞóÛÈûÎ4cåù],4&ÄoÆ$ܾ’bû«½QcýÐM€é9âwœ¿•Uý¦‡_*L¼ª¥þÓŒ%æ«óÛ¾Rù†féhWÙ뢄îLÐîü H#ä´â\ç‹Em{áÝîãÿ‚1¿„Cødþd»L{~$bI J?¦riÀ˜$§o?&º¹Ä py—Ù5Öݘà9â7LŠß†šÁÝX¥ðc®–Œ‰Â{ÿÒ͉ ÀW;{£hú¡›S»ó;°ëõ˜ýìh L³â·7²ƒŒ1'-ú˜ª¥c²7ór°`{úÝÈp*ÚUöFõC7¦çˆß0+~1@ñSRÌ…ÆT- „÷”TÈ™nzLàT´«ì¢é‡nLÍÎïDªj›PG™%`²³ýñöì"IWû˜ÐA “¸nN8Üþ˜fÅoß‚#©mMŠvjit*åÒ1Ý ï®ÆNE»ÊÞ¨±~è&Àôñ¦^вµÿ°½Ð˜Ê¥cÂï)©nsÖv¸¦X–ÙEÓݘšß¶ñÔ4ú/WHœ/FI)û¾ðÒ%^ÛE[…l»j2ŽùÉ—çÇ3®1c»”~Ð(T ¼¨—ŒÉ8àUcä¶S75v¶sWÙ5Öݘž#~ôí‰ú¾ÐvKå•”jiĘ˜¿¥›¸¼LÊì¢é‡nLÍÎïd¥nOô`o ÓÚø¦×‹ÑÛ·$ñY¼+ç·YÔžý)ŠmK>ÙÇÓ¶'ö@ñu—r+W,NåÒ›1Q–»S9¸¼LÊìë‡nLÏ¿azàe&WªíŸŠ“ziÀ˜ ¼ï1½ìæÄ¯)–eöºh¡{6;¿&!ÙoK‰péJÊëÅ~'14-žÊ0Ew‰õ Zã[z¿&œ¿•l'n_ü^œú‡µn±4rx]J:“_½¹©±øÕÎÞ¨±~èÀ„Ï¿q¶ó8çh{ë¹bLåÒ€1EÁëÄÒm»žíÜUöFÑôC7¦fç·ØoÁïÑwŸýdLþbLŠ~)EV¬ ÆDÆ•$øÉžaÛ'OåpZü†£…= ¦²Á²Zù1½fÉŒIòÝEq¼í2{£Æú¡›ÓsÄoœöüæcT÷…ÆT- “=§¯§È3àeä]foM?t`jv~KŠà³bsÈii|ÓëŘ¢ÚÖeíJŠ=€ª(Ñ13ó“À4m{¢n?ê·”2—¶'åÒhÚ3½o'¸ÙÊáåeRfoÔX?t`zŽøÓâ7qLAf(©Zê?Í(ç÷”`À;`ºí2{£hú¡›S³óÛžæ äãNÜÊr™1)ø¬KE¡ewðÉOšÉÏ ÂGû˜p¶ó;(Ø·Ýv—¤ZŽ¡/—FSÌïÙ… î,ñl箲7j¬º 0=GüÆYñÝR”Û0ßÕRÿiFß]¹þô¹¦SÑ®²7Цº 05;¿Å6“Ûëº_˪Æd/NN³íêÚÆÆ5*q&üI`š¿ ]S´Ûsåçï^MIIÇ£é`L¹àT´«ìë‡nLÏ¿qzà¥D{D„ˆTZRÔKÆÄz};0Ü]â¥kŠe™½.šAèÀDÍÎo±_Ù¿ºnòÂÁ¼^œ[rÙð}ÜŠT0¦ é5ôƒY?z%…f=¿ì]ÈÆÿüxµØÊ•K#Iä­1ñÝPU ÓÈ»ÊÞ¨±~èÀDÏ¿i¶ó;#v‡#Éå‹jiÀ˜P.Ænšß¾ÚÙEÓݘšßVäÁÇá¹»-kLöb{p“"¬NI1š¥L9©;gÆO6XÒôÀKPöÙŸŠ±ØÊÕK#wë>&½¿éšbYfoÔX?t`zŽøMÓžß í „ ÀTz~—KÆ.ÆíS¾¹’B—‘w™½Q4ýÐM€©ÝùrLBÞ©„–€éõbÎѯGëY=•‹b;‰‰cÎüÉ>&š¶=ÁÀ-k„Ë­\µ4êü¶ýü[c’»vº¼LÊìë‡nLÏ¿iVüŽÁ ·BöéÅ•”j©ÿ4CÕxuåÚwâ®+—䫽Q4ýÐM€©ÝùÕ')Ù†#¯µ ¼^œ|¶C ·dZeLä$-Û{•å£Ív~ÛŽÒHœmŦâoµ4Ò˜8¿Oåò]íÜUöFõC7¦çˆß4Ýùmä*£wãe,4¦j©ÿ4ÃôÝùmO º¹’BW;w™½Q4ýÐM€©Ýù p8IfÈهǬ1&wä¥l¤+®\´{Êù} ŠÑÞ,ÕOžÊÑtç·ñ>öŠ`†˜ª¥Ñ©œæë{@.ÝÔØÕÎ]foÔX?t`zŽøMÓßHú£FX- “=⯧Y 7'&|µs—Ù뢄îLÜìüNÇñ3æH>‰iqJŠ¿XükgÛ1]k°ô>&1Hò¯Ê';¿yÚö$û,Iˆ¸ôcª–Fß!¾;¿)æ¹€//“2{£Æú¡{?Güæé—ÑÓ=~‹“jiÀ˜˜èÚÿG¦|ÓcÂ×Ë2{£hú¡›S³ó;Ep Ú¶Ul¿x*ç/N‘’:.±¥dLn%jÊÞ™óI`š¿sôF’Äx|5í¹\¸¤æËZ×Ü6ñ2~µ³7j¬º 0=Güæiñ³K~~¾ÜÊKÆdÁWI$¤a’/E»ÌÞ(š~è&ÀÔìüNDLˆÂ!¨¬ØvÃùbìÚ÷ÚˆpïÔ p3¨ì½LôIk]ž¿“ßéÖãp$üÔ1ë¥Qçw ×É/a¼FÀ§¢]eoÔX?t`zŽøÍ³â·d¥äfû&O³jiÀ˜ß}Loý˜Y¾ÚÙEÓݘڞßôòóQ'´Ò# ç‹‘b°/žàø`­dL9qÀÈ)Féý˜fÅow»c4LA)~õÒhÚ³¤7cŠ· –|*ÚUöFõC7¦çˆß<ÝùÍ~¯Ú@…BqbR/ “O¹p¾+š«»ÌÞ(š~è&ÀÔìüvU‚ÑÎ~Vý˜|#f›‹ÄqYcÊâc®íK>9ð’§=¿Á¾öl;L€TSµ4`LÄç%^{jºs°àËÈ»ÌÞ¨±~è&Àôñ›gÅo¿TMÙ'j!”[¹riÀ˜ü|úbLñu¶Ñ( _íìuÑ B÷&iv~é Ù¾:nˆÈkFq¯»OœÛ`Ò ªŒ Å(šd{«|ðI¦mOÐïþy#;R±•«–FÓž¿'ñòæ›&^¹¼LÊìë‡îLòñ[fÅo&ÛÉ1éO‹­\µÔš¡]Œ) ÞÓ©hWÙEÓݘšß‰Ô6ê­Û¸z*g/Îè—Jˆxm+g‰»êö®¯qkço€i¶óÐ¥eÍÁ­kSµ4šö¬|ÕæWx«ÆÎvî*{£Æú¡›ÓsÄo™¿Ý5mãžà5>ðÀT-õŸfSº¦¤¨ËBß?îGÑœŠv•½Q4ýÐM€é¦ó›%RÎ9¹iÛ0½^ „Y%¤5£8÷c¢‚Ɯ䣓xe~à%¿…­¥ècª–ž_ù¥2¾¦=£ÞÈòžbYdoÔX?t`zŽø-Óâ·báCkåÂ(®Z2&¼4¦cüÐ 0]Šv™½Q4ýÐM€©Ùù-™}´‹LdˆeKQˆ†È1LŒ†+S $ö K„úY`šöüÎ~èeä1J1ð¢^x~1§·Æ„€wŒé2ò.³7j¬º 0=Gü–iñÛï{jÊö=(û˜ª¥cz]Üõß1Ók®\ ˜.E»ÌÞ(š~è&ÀÔìü–C®G1ÒÃqmDøñbßT¨íÈü¦ÝºÆ|.ÃáCóA`š¿ÀÙþR¼¾¿Ë¥c"Î×ɯÝ»¦KÑ.³7j¬º 0=Gü–éÎo{ð‘àŽ‹S¹jiÀ˜|$åù4»Ô 0¥«»Ì^Í t`J7ß!±êÁ›‚®NIñ§@ýtsñT.ú8¿dáLóƒÀ”fÅoŒ!GUCÚP¼¬–F“x0^}Lö¿òŽ™NE»ÊÞ¨±~èÀ”ž#~§YñÛʹѰÉ8ìOa²^0¦„ï)©öÌÏá˜NE»ÊÞ(š~è&ÀÔöüN,Þä\+Z1€ëÅ”âkÂçâ””¨(è§¢.žôT.MŠß’ˆ„@Á=’ÖX½4p°PU8k |"è 0½í:{£Æú¡›ÓsÄï4+~'Žì®þ¹ü¦ji¤1e¸4&‘Ó4®Q4§¢]eoM?t`j{~£ÏÝc=dº8‰×_ŒÞQêcåÖ¶r~(³7WØÏEø,0ÍŠßÂFwíw’âO³^x~1'ªH|*ÈcŠœ¼í+øÞd<Éà7À4-~S6ª d{Z(,Ë¥cJ¯É(/éõ˜jÓ¥h—Ù5Öݘž#~çé—™1$ÛmPÔB˜¬–Œ)òÛ]0ú•Š`º¦X–ÙEÓݘšßÙ€™€U! ¬žÊù‹£ÑDDŸn¼Øùm´„‚¤À¶Ùú(0Ív~„Ùî’‘¹œ]X/ SÂoÆÄ¯a ˜Îvî*{£Æú¡›ÓsÄï<Ýùmßñ¤eSµ4`L!!ž¿c¢—~«h®vî2{£hú¡›SÛó;û¯+†-—;¿ýÅÀÑGVQ^íüV×aŽy™Â.»ß”Òïiºó›;ÒaêYº TK£Ù…Àï>&ä»Îï|µs—Ù5Öݘž#~çÙÎoÒ`ìÕø’ÿxbR.õŸfÑ-ž¿cö»çþ…ª‹FÏvî*{]4ƒÐ=€IÛßYí!œÁ¾Kyµó;«($ñëæÖcJÁ0<ÙË9º3ïIg;¿%Ø·ÝÁÒ6JåV®\0&Ât¹ ¤;Ƥg;w•½QcýÐ=€IŸ#~ë¬øM()Q€èƒ† `*—úO3ÛfÉu%E£ïÿ›ŒIOE»ÊÞ(š~è&ÀÔöü6\È1bŽx¥yÎûp"¿V¢+óÅ1‘}Ãìå>È]†> LÓâ·ø ™è&‘©l°,—ŒÉ­Ì/Æ_Sy[5v)ÚeöFõC7¦çˆß:íùMî'â'¥T^â­–Œ)c|[ëúZ[cÒËÈ»ÌÞ(š~è&ÀÔöüÎ)"'cyÁxÞ‚sÉ‹1¥àcNЕñ=ܲó;øOfM9Ûóá“À4-~GÛ!eŸÛ"XÊKÆ/Ÿ¯ðš…~w%E/E»ÌÞ¨±~è&Àôñ[gÅo·­ÍÇ ?¨zLÊ¥crãÅ·0™è¦ÁR嫽Q4ýÐM€©íùD]!b1ªG‹ßþb&ô) >áa ˜„SJ~–¯”$¹ºEŸ¦Yñ}Pzð‘RTޝ–Œ)Â[.ˆªéŽ1Šv•½QcýÐM€é9â·ÎŠß£pÂøjðÿã©\¹4`L’åmIa;¸¦SÑ®²7Цº 0µ=¿S#y)õ¡Jx½˜S$Žöݳmì¢í‰o“†d'ÄôIÆ4+~f¿}‹ÙHoÑÄ[- SÀÀçÃÏO.ï“~µ³7j¬º 0=GüÖYñÛj7¹"D)–¶'ÕÒ€1~#D”v»†SÑ®²WE3 ݘ°þè^ßVá³Ò2c¢ìö ¾L´âËëEC,€$ûéǑއ€éüx&j,ø.Épåœ~^{ª—¾ò™ø:ùõ¡ LÎvî*{£Æú¡[†Çˆßçû=Q4b¡9ùQiÙcR/ ¸Š†}>× 0]S,Ëì¢é‡nLwžß½;òhŒY¦×‹!Ú¦‚1,_╈\|Ït´ ˜fÅoûØŽiVÁo|üdLÕÒ`mr¯–h¼²Ý.€áT´«ìë‡nL¿Ï÷{\4ÙgÜ' `ûX4XVKÆDÂ×Kû|o¶rö0ÿjgoM?t`jw~{¯€ˆý¾Á›,“?¼YRV΄‹¶' ~Ÿl?û“À4+~g$%CX7û+û˜Ê¥c’ôöü6†~3%Ŷ{_íìë‡nL¿Ï÷{\4™‘ CÜŸ˹rÕÒ€1ùÔù;JŠÀ7Àt*ÚUöFÑôC7¦fçw J˜ìù`;*M‹ßþâíÉíæ¼º8"<ùƒÀQUý@ð“À4=ð2“$ô;6$%c*—Œ‰ó{®\´²¸cL×Ë2{£Æú¡›ÓcÄïóým«Õ>aˆáPJjLåÒ€1aÀëº@’ï¶rW;w™½Q4ýÐM€©íùm7ëcN Vel>Rø1Ù‹A„%Fã>«ŒÉ} BÈQ”cø(0ÍÚžDæÕ(I9"¬Z0&#Í—ƒE´§U{à%†ÓˤÊÞ¨±~è&Àôñû|¿'ŠÆÍ] QF.:¿«¥cŠú¶¤È¶¹¦x*ÚUöºh¡{Slv~û(kôA'ìÝ]‹§r¶Tµo`r»ý•‹v‡ÆäþrݧÎ5¹Sœíü&ñ^Ñ !¤²] Z0&äpõ1ù„ð›­\<Û¹«ìë‡îLñ9âwœ¿ƒo«Y“Bñ4«–Œ)&|w~S–›­\<í*{£hú¡›SÛó›!iˆÆ]lK‹ßþb{€‡  U”s/ci>½ ìÃÀ|4A} ˜&Åïì^nùuÓ팩\0&c.ƯVÈ0áW;{£Æú¡›ÓsÄï8+~+%u72Û*•WRª¥c L×KÕ˜ÚFq髽Q4ýÐM€éÆóÅ/«Ñ#\¹Uç‹Ñ"?—[spóPƒÄœ™%;6}˜æ;¿]W6òÇ”Ë+)åÒ€1EÑK.°!·ý˜0¾Û¹‹ìë‡nLÏ¿ã¼í‰o:Œ¾º$Q0¦riÀ˜BLá]4Ao„Éøö2)²7Цº 0µ=¿ArÊiíV œ/æˆî$ ú¥E=,?é.p~<ãKFt³Š7W)[¹jiÀ˜"àõ=ˆñe­Óª±SÑ®²7j¬º 0=Gü޳â7“OlçìRHLÕRÿi¦•7E#7&^OE»ÊÞ(š~è&ÀÔöüŽÞ¹ ª¨ºx%åõbû«“‘ª·Æ˜0ùˆÍ€€Yô³Ólç·0«j¶‡K®ŒâÊ¥cr Äëá ܈ßñl箲7j¬º 0=Gü޳â7ĜضJ*©˜’R-õŸf¶{pÓa<íÑ:§¢]e¯‹fº0A³óÛMÊmS¥¬>Áiẜ/vOä÷¶lYx™}Dš[ ÄžÊÁ¬ø­™ˆÕˆ¯²ü¦jiàù¥BW¯æö}L„SÑ®²7j¬º0ÁsÄo˜¶=7Í÷©Z¹ ÙõRÿi–X«YcÂx´©µ€éò2)³7Цº 05;¿%Ù^.Ø#8ñê]91+û0Þ$ãÑpÅ]9û™ÙÞ}ôÁúÁ»rçÇ3®1ŸÛIö…7°äTSµ4pIÕ¨z2&XµG„[üjgoÔX?t`zŽø “âw28 Ù[”)§‚fWKý§™äÌx1& Ú6ñB ¯vöFÑôC7¦fç·c´*?z°/oz½Ø/ºpZtˆrŒ>³8¸ÎôI`š¿™Ô/¡ù #bLåÒˆ1Å·Æäó™oN~áT´«ìë‡nLÏ¿azà% ¸¶,öÑ”/Ë¥Á\ù¬ðfLöÚñ®)–eöFÑôC7¦fç7{O¨sH„«ßþbJ—PÝûdÑ(Î'Ù‰HNêòðçlOÎg\cÉUüLèèù§ŽY/ gêuí)…;`J_íìë‡nLÏ¿aVü†Ã‹,°=^¥ècª–úO3Ž~EàdLƲoŽráT´«ì¢é‡nLÍÎoN’Õçº)@H‹ßþâd\ËÞÑ„qéTΧ³»1HÈá [ü)`šöüö/>D×`¶¦jiÀ˜|\Þù=0$ÑpL—‘w™½QcýÐM€é9â7ÌŠßÑõÄ ÆI˜ ?¦jiä.(.Æ$oNå0|µ³×E3ݘ°ÙùÍîl_]'ñÚ‹1‘Q-¶´Ä˜Â_ÔG¡mç •âa{ò)Æ„³âw2êÞöé¾"…\P. “aÑåùíãóÚ.©ˆ§¢]eoÔX?t`Âçˆß8+~£¼ ª§µû)©ÅÒ ÇÄ;.Æ$Â7G¹x*ÚUöFÑôC7¦fç7K)²ú%\•EÉ_ìãQ¼Ý/Æ¥S¹?{?*‹¸•í%é“â7ΊßÙÇŸ‚w}:fµ4`Ln[q~HÏ+P;í*{£Æú¡›ÓsÄoœíüfoZ´bŽR˜xUKƒ§ScJH7×ðl箲7Цº 05;¿™ãûÏÌym|ÓëŶ³h[—EÆ„î~ ²[ÕÅOÚžà¤øí—мkÿp1/Yy¹4ª±®»rnRrǘø«½QcýÐM€é9â7ΊßöX³}¤l°¬–FžßébLnÆL§¢]eoM?t`jv~3)±_Ìq÷¼•)ßp¾˜Ø¿|Ôú¢í‰ýX÷ôuëo׸> LÓâw°§ DÒ(ðóáW/ ¡^SR8ßx~á¥h—Ù5Öݘž#~ã¬øí–B*Œe»@½4èü¶'Îõ Œá溞Šv•½Q4ýÐM€©Ùùm»)"!àh±É_ŒY²ÊÒ|ñcú5=ÛÓùd»Nw~+¨;ñ‰ƒÂ©Z0&¸ú˜À/#ÞÓÕÎ]foÔX?t`zŽøÓ/áøê»-SµÔš¥œÓKÒp£øt×.@×Ë2{]4ƒÐ=€‰šßld‡4q VÝŽSdu×pYêcòü0K·×û$c¢iñ%Â2R.€©Z0&8ÁèO/&}ØèR´Ëìë‡îLôñ›¦Åo+^¡à7…ÊvjiLhØÀw –t)ÚeöFÑôC7¦fç7çì÷Õ3%Ô”—û˜ìÅþJ ‰WâT}˜Œa¸½mBŸ´=¡Yñ[Ý­Ýÿ x9Áÿ¸’R, SÔp1¦òÍìBCä¯vöFõC7¦çˆß4=ðÒ>‰¬2d-¼rª¥Ñ0¢Kcò¡¹á˜®)–eöFÑôC7¦vçw°X°]F^uð£Œ{ã­‰ßnìÀœìe.ææq¯Áo€i¶óÛhf–È’RLÕÒ€1Y‘]ß{wšÓž‘Îvî*{£Æú¡›ÓsÄoš¿£³+Ûm`ÈEó[½4&cæóTλ oNåèT´«ì¢é‡nLÍÎo h8­¤¶§‚UÆä/¶ïø>СxíJŠ[œD•> L³â·o‘‚O¢=\~Sµ4`L³žßJå˜NE»ÊÞ¨±~è&Àôñ›¦ÅoHÁwØ>ﶸÄ[-lO_Vc2¢pã.@—¢]foM?t`jw~Û–#PJ #tq®œ¿|oN!¬ÅEûòÛ&Š9 òo€iVüV`?º`¿Ñ\ ¼¬–'¿úºQplå ÁÍìB:í*{£Æú¡›ÓsÄošxiOç ‰Õ§ýS¹4ßèhØ9úy˜øšbYf¯‹fº0q»ó[#ä‰mÃA+÷páõb rˆ»ö]YfLSJ,LFœ> L<+~cp6ûòKÊÅ%Þji d…Kü† w¾ò|*ÚUöFõC÷&~ŽøÍÓ¶'‡‘’{–§råÒàJЦôÖ˜Ü{ñ˜./“2{£hú¡›ÓMçw~m?ƒ"®må^/NÑ=æüXoñT.kRÍÃÿ˜¦^f?†Æ¹FP.zå^—Ãv¤zc{Â×Ë2{£Æú¡›ÓsÄož¶=ÉÂb‡™Ê£Ürip‰WûóøÕqÔ¦ËˤÌÞ(š~è&ÀÔîü¶§ûž FI+–J¯»rhÜ“íÄ|ÒÉ*cJîõ‰h‡1€OÓ´ç7Höë“PNâ­–Œéhâ=Åoy…´€é2ò.³7j¬º 0=GüæéÎo#þâ7Û¨ôÊ©—úE#œ^b¤?ÍXù¦]€¯vî2{£hú¡›S»ó›!¸"¶'3€YdLì"/ÝŠ aÑ(ΓÑ-(ibø`š¿§?ŠÊ$ZSµ4`Löw]í„’î¶r§¢]eoÔX?t`zŽøÍÓ/mä]3Œöí/4¦riÔÇdàq1¦ôŽ1]S,Ëì¢é‡nLíÎoöaVphD¸Ì˜ìÅ>­’¢±&^š+wœÊ6ÄÞ°Áaxø7À4+~§ÃPSmWK±t(—F-)!_Öº5ÝXëò©hWÙ5Öݘž#~ótç·m5üî‚O(âÊ¥~Ñø±ø[cJù®]@®vî2{]4ƒÐ=€IÚß,¶;ÜÊ)¦ƒ€c’ÈÆ9ÝÓ VèÖÙǨ¬‘ŧ^~˜dZü&N>\àe¸üGñ»\0&‚÷ÀK6\ºi°”KÑ.³7j¬º0ÉsÄo™¿}j›=zŒ÷3”7¿Ë¥~Ѩ«*cRL7WRäT´«ì¢é‡nLíÎoÆä”„ «wåÝâÜ6òò©œ½oîÃÂgÛdVüö©/D‚Y˜~Þ.¨—Œ £¾âæ;`:í*{£Æú¡›ÓsÄo™¿ÝL cÍRú1WK£—ñý4ÃôÆÁRNE»ÊÞ(š~è&ÀÔìüfQÛN©‚ï‘UIì/% Jˆ(‹“ñ4Í*!F5¶öÉ))2+~g#p’}åc9¾©Z0&ƒùk|SJç¸ðFŠv•½QcýÐM€é9â·L{~»­´Ÿls*Ç7WK£—®®\ÐÛ¹rry—ÙEÓݘڞßÕhß“ «wå܉)ñí¬2¦ìwQ Àc ŽQ›¦é—Qì­Fws¡cÖKƒ‡_|ÙéÃØ­œÛÀtM±,³7j¬º 0=Gü–Yñ;ù)'oªNåÊ¥QÑàÛ(}ì 0å¯vöFÑôC7¦vç7G¤@Yý gUcŠ $à:¶¬Í•sþ`pèã(jü(0M‹ß)ؾ–Œá¤\t~WK£‡_ÆxÖ˜F¼;•“KÑ.³7j¬º 0=Gü–iÏoM\¬-zLê¥Í~¹%=&QåÆ)]FÞeöºh¡{Sjw~nˆ~[.fÅI¼öb ¤î´b‰GT´m´3??i{’&Åo'nî‰k¿XJåÀ‹ri(ÀŘb°Š¸©±øÕÎÞ¨±~èÀ”ž#~§YñÛOáŠdûWé`Y- Šætä>ÓÙ Ù*šSÑ®²7Цº 0Ýy~G…ÌS—;¿¨ y³;,žÊ¹Å¸ßÑË`ú¤Q\š¿ý7 öç@®,Ë¥Á‹Â{ÚsÐ;‹t)ÚeöFõC7¦çˆßiÚö¢[úˆù)LÖKÆ„‰¯{LÞptÓ`™./“2{£hú¡›S»ó›](Ê‚¨.{~³í[1ŠÏ×åS9÷®vŸXQÛrAšõünòk¢½å$žjiÐ’"¯+:‡¯|Lw“xÒiä]eoÔX?t`zŽøfÅo°½µ=†Ðë¬h°¬–Œ‰|ZÐɘÀ»ÀÛEs*ÚUöFÑôC7¦vç··8Š÷:Úc}ùT.iDJÞŽŒ—4¦ðcY!¡¸‘.üàø¦4)~gï5u3B±•«–ú¿ß“x éÍEñ”¾ÚÙ5Öݘž#~§Yñ›Ž£eß3`á•S/šß8¾5&ðjÍ©hWÙEÓݘÚßüÑ2Ò ¶œî£û ïÉÖ¶r ",â“R>ɘfÅoûeR°=˜[ê¥þÃÏ.Ï/cèáNÇ<í*{£Æú¡›ÓsÄï4Ýù¢’A*GëTK£ë¯“¸ƒ1v[¢ÉW;w™½.šAèÀ”Ûß9Ä,î$Jñuh¿Â˜rðFB Ù¶kŒ‰rŽAƒýOnåòlç·ØßÜO[b,N媥þÃÏv¨úžöL1Þ0¦|¶sWÙ5ÖݘòsÄï<)~{cYÄ)—O³jiÀ˜„U.ÆDo,3|µ³7Цº 0Ýx~S$RÛÌÙ.tÙ)h4’h_½´:ð2‰úˆû¢1~’1åé—Þ'굡´Ö©—ú?6Vƒcâ¨7S¾¦X–Ù5Öݘž#~çYñ[ C$Ûþ:J1Á¢^0&É|õ˜ =¯ohv>í*{£hú¡›S»ó;EöáKBKî¸/ÉoÑû(ߨqÅ0üF`?2K„è×+â'‡äÙÎo{¬h ߨWRª¥a6оÛÆî¦ÆÎvî*{£Æú¡›ÓsÄï<+~3Øc"’÷ãAÑù]- “m!®{Lhߌñ;ŸŠv•½Q4ýÐM€©ÝùÍœ@¢BHÈ+kç©\v Ö› šç·_â9ÚWÌ;LJ·ô~LÓ/#*MöquW®XØ7+Áu3ÚkïXù5ŲÌÞ¨±~è&Àôñ;O{~g @²ßÕÒ€1Ù×H.Æ”(Üô˜äËÈ»ÌÞ(š~è&ÀtÓù­j`«õˆ«ŒÉwq’¨qĵ­œkÂ1Øs?‘$ü¤Q\ž¿#[l`%âb¨j½Ôø¡¡î›1„ÐMŠv•½QcýÐM€é9âwžxí±„¨0ñª—SR}» ÚFä†1é{Še‘½.šAèÀ¤íÎoŸòm¬øèsXdL¶s ,*,޼ȘüÆ—O G#NòIƤÓâw"ïa×à²PÁ˜Ê¥Ñ\9IïS9“Ƥ—¢]foÔX?t`Òçˆß:m{’\õ ),ê¥QÑ \ŒÉøÜìÿõò2)³7Цº 0Ýu~‹O8ñçpä%£¸ãÅ)»ÈD‚i¼+SÌná}rñ°µó7À4)~Û%@Š` ]#¨—FM¼/ªƒ1ånNå¿ÚÙ5Öݘž#~ë¬øÍ¶éRð¶2ÀŸ§rõÒp!_¿#ú$œ›¢9í*{£hú¡›S»óÛÅúàÿÀ¬ú1If‚ã@„W‡dÛáÉdTh‚ú 0ÍŠßzXrÆã”ñ§a½48•ƒø¾Ôl¨ÜôÊé©hWÙ5Öݘž#~ëBç·&Õ— ûO`ª–Œéð÷¸ÞÝcÒïvîŸÙEÓݘn:¿ý6J”˜l º"§r²÷~3ÉJ¯í¨‘(…¤Þ(ÿA`šíüÉ;cQ¶‡WÁ˜Ê¥A½¶¶.„»‹âš¾ÚÙ5Öݘž#~ë¼ç·¾Q²m<Š­\µ4`LðÚSRC¸»Ç¤o#ï"{£hú¡›S»ó;Sá’í©óRä«)û¦dÁ°èùíÄÕ¾‰0'„±áÊo€iVü#pÇœ[?Ä(4¦ri°•‹ß}LàM^75¦_íìë‡nLÏ¿uVüÖèW÷s¶O¹81©—O3ÄxÍü"û2¶Åoƒ¬¯vöªhF¡[ÕÝɘ²±–DÌ™ti+ç/ûþÿ ÎOåìû„4–)áƒÀt~<ã3€Ì$è7–r(Äïji4𒎱Ƈ¯¼»ÆÝÔØeä]foÔX?t `¢ðñû|¿ÇE“mÃ!îÂj/ÁâT®Z0&F¹&X&låR8í*{£hú¡›S»ó;¥˜4$˧r)û~Œ“O~Z»Äë;œl\†YÐö½Ÿœ+w~<5½ñ!«ýB‰ªK¼ÅÒ Æ$ƒ¾SŠw5†_íìë‡nL¿Ï÷{\4É‹Åg3f-šßª¥cbÐËÉÚâ7…kŠe™½Q4ýÐM€©ÙùmtÅwa( `to1Ù‹1¢Ï„¬+c|Æh< ŸBTü$0ÍÚž‚Ø÷Ý>ƨTöÊ•KƒKÉ’/Æ„éfàþjgoÔX?t`zŒø}¾ßEãgi9ˆñÂ(®Z<͈õrô›«wEs)ÚeöFÑôC7¦fç·ˆ+nr8ÜR\<•³ÛDܵ,]âõï«= \—cÌ‚ÝÊMw~‹ý"â}û9÷1«¥Á•Ná͘|ÚàM]íÜeöFõC7¦Çˆßçû=Q4‰£+ŠXC1%¥Z1¦˜ÞSd½+šüÕÎÞ(š~è&ÀÔìüN1iVCµýyËOÆ” ‹ÉËÙ[ê«×q`L ŽKøÁËó㙨1v[ª 1‚`1Œ Z´ P–·Æ$,w5v*ÚUöFõC7¦Çˆßçû=.šL 9¿¬óË>¦ji¤1ÁÛ]€üÂV»hâÛˤÈ^Í t`ŠÍÎoïm´_V”rЕyðz1ú±œâ]Õ˜ì‘oi{Ûò¸×àÀgÅoöÉÐö¬²¿FJ`*—¶'ÞÛu1&'–75¿ÚÙ5ÖݘâsÄï8+~£ÀRp›,)&ñVKÆ$Äo ¼é¸]4§¢]eoM?t`jv~§,Ü[Õ¸Ïbç·½íïû{I ‹}L>\(–Ó´í‰ €C/¯¤TKýó‰ÌðfLzwÀ//“2{£Æú¡›ÓsÄï8+~+©=_ ÈBÌÅ\ùjitb¢éú ^&¸­¢9í*{£hú¡›S³óÛåcHgBZôc²Ûl”‡ ‹ÇúuÑùm$Í~´›AIïLÓâ7§@lŸŸm2ËiÏåR¿ÆR~3¦ tÓ’/E»ÌÞ¨±~è&Àôñ;NŠßÞ dñIüJ×O`*—FŒ Ó5‰×ž¦7WR(ÊW;{£hú¡›S³óûðÛö{¼Éǵ/ÓñbÛ¸Fc\ìÓRïÊeQEµ¤ŽÇøþ˜Äo’Àö~`y%¥Z #0dºNå0Ÿ¼©±oEûgöFõC7¦çˆßq¶óÛžêAÕÑ[¹jiƼ“ðêüÎ7“x)žíÜUöFÑôC7¦fç·Ú~Ê0%wí^+§>VíýtGYuH><ƒ¥ôÉv8-~Û/bdW•D‹Îïji0¾É(ä»óÛÞ¦;Æt)ÚeöFõC7¦çˆßqVüFâm‡”H ¯ziÀ˜ì©ó­1EºaLp*ÚUöºh¡{4;¿£m=5(g´­Õ1¾é¦”ZŒÉ^l„+ BÎ4ÿâ×ø&¶ï—Ì´ ~Ð]àüxÆ5–0ùüS÷®Ë¥SµÔ¯1u½7cŠÒ¶=±êûjgoÔX?t`‚çˆß0=ðÒûðØ ª3ý,šziÀ˜rÆk®ák*o«h®)–eöFÑôC7¦fçw4`H`àäŽqŠ+Àä/æp¼Þ[4¬“û1…c&dÛ›Œ§eþ˜fÅo4ú‡c,.Š×K£á®I<¶Ë¥›­àW;{£Æú¡›ÓsÄo˜öüŽê‡7¶]Ù¼ýØÊKƒ®Üð"Ácb¹k~ƒËÈ»ÌÞ(š~è&ÀÔìüŽÁ»õ83‘m?u•1‰0«ýÉW¸ÈäξA"|Rc‚YÛ£»ÆQQ4:fµ4Î95ÒÍVN/“*{£Æú¡›ÓsÄo˜íüÆèÝ´ö½7()ÛÊ¥‘íiþ¾+çƒ:nŠæl箲7Цº 05;¿í¹‚· GYdLöb#KÑ»#r ‹Œ)ª½M>7ßÒû 0ÍÛžòï{v2÷³Æª¥‘»æ«Wìe7-)ðö2)²7j¬º 0=Gü†iÏï” ù½©î1KÆd»ó·“ß¹)šËÈ»ÌÞ(š~è&ÀÔìüv7&Û|2p@’lóÅÙÀ%älÀ–SD Þ̤ÙPí£Ó¬ø}˜i%v'òXhLÕÒ€1½o`¼mýjgoÔX?t`zŽø ³â·Mö¡°`,zLª¥cJ|MI±mÈ]W.žŠv•½.šAèÀ„ÍÎoûÒ0&Ÿh•%ÁÒVîõâýV‹+ç />“QK£öEãøIƄӞ߆Í5 ßyü LÕÒÈZ7Æë{€nÃwSc—‘w™½QcýÐ=€ Ÿ#~ã´øM9OÕ¢ …Q\µ4`Løj<Sb¹¡Ùx)ÚeöFÑôC7¦fçw¡Ñï÷g?XdLÂîÖ‰Þò–¶r.À«Þ®òÙÿd»N‹ß”Èú9£–~LåÒ€1!§KÇD?¹©±KÑ.³7j¬º 0=GüÆYñ” “¦r´N½4`Lù}*§¯é\­¢9í*{£hú¡›S³ó;‚Ƙ²wH&^eLj›@{9$ ²Æ˜¼µRÙ£!¡~nàåùñŒk,ÙwÕ'Ijcª–Œ‰â÷$žøIߪ±SÑ®²7j¬º 0=GüÆYñ;«b°O%jþybR/ “} ñ|šqù¦ OE»ÊÞ(š~è&ÀÔìüŽ>Š Ñž ëŠ÷A¡ýC°¢œ{Ñd%Ä ~ž? L³ßš9û\aÈňðjiÀ˜¼ÏèbL ·5v¶sWÙ5Öݘž#~ãtç7øñJT/嘪¥c‚ð>•Ó[a¯vî2{£hú¡›S³ó;ŒX¥g/ÏïÆd/NIÐïº,µ üù/Ylßkß1Ìd[¹ôI`š·=”|”2q LÕÒ€1±‘ç‹1á½\ðö2)²7j¬º 0=GüÆéÎoÛXsbŒËS¹jiè.øÍ˜â݈p¢«»Ì^Í t`¢vç7L’0gJ Øg¤Sûæ1,jL[²Ÿì-#¬áƒÀD³â·Ïß6ö(I§rÕÒ€1¹›ùŘ0ÑM¯ůvöFõC÷&zŽøMÓžßÉXƒûÉ¥çw¹4`LöÔ¹öÿS¼+šËÈ»ÌÞ(š~è&ÀÔîü&"vK$ÕóÒVîõbõž?ŠîƱȘì'Ú3"¸ÍÀGiVü÷Z0óŸ,õÒ€1Ô_'¿~Œv³•£SÑ®²7j¬º 0=Gü¦Yñ;SvG±àZiaW- SŽáêÊuéö¦Á’NE»ÊÞ(š~è&ÀÔîü&ŸÝD)@p—»UÆ„ÁoF$Jn«¸Æ˜Ôö"d_1¤`»ßOŠß4k{b¿û¥›jrAµ4`LIèšöŒî­sSc§—I•½QcýÐM€é9â7ÍŠßn¯nÝã ŸES- “Æ÷\9F¸}šŠv•½Q4ýÐM€©ÝùM)±÷01G¤…ƒ58_¬~EU™%,\´{õ1ÅhHAÒ'û˜hVüF£o‚n´±°o®–ŒÉ8àuWνÍïjìT´«ìë‡nLÏ¿iVüQ}n.ø•®Ÿ[¹r©ÿ4£ |õ˜0ãíÓìT´«ì¢é‡nLíÎo#yÇ \–´‚-p¾Ø^®þÐ0×Éœ+ &¿o÷Q`š¿sCÚBŽŠkOÕÒ€1)„w“ß¼©1ýjgoÔX?t`zŽøM³âwLY}ËáÅ•”bi0ÁÂU‡‹1Þ ‡¯vöºh¡{·;¿ýÒ1C¶Ùsxõ®œ½Õ'7E€åüuWΨ’1.J µÖåéÎoÛ…ƒý‡­VS±4p°ðYžc²î]]íÜeöFõC÷&~ŽøÍ“âwr31rV*{LÊ¥cÊß“_ȸ)øjgoM?t`jw~ øc®Ñ6«îbÛ‰ho§¸áÞRƒåqؾ±Ñ¯o|Ô(ާ=¿iDã©0#¬—ž_~D{1¦œïæÊñeä]foÔX?t`zŽøÍ³â·{ü<>úpÅŸŒ©Z1¦øv`D¾¦SÑ®²7Цº 0µ;¿%øDH{‡K%8_œ8_áŰ|WÎöqbû@Méµü0Ív~»Ñ²}ˆîYSµ4`Làª1Ì|7Œ€Ïvî*{£Æú¡›ÓsÄožîüö©Ëö¯ËÎïriÀ˜ Çëæ·;”Üô1ñÕÎ]foM?t`jw~"ù´)ûÅ#¬œøÃùbcŸ¤Y€WÚÆ_SpE.HNqb¢Ýo€iºó;Äœ²}ŒÇŒ“Ÿ¬¼\0&ð—'cÒpwQœ¯vî2{£Æú¡›ÓsÄož¿cÎàp—þ)~—KÆߌ‰óW_Šv™½Q4ýÐM€©ÝùícJ\_b`X¾+'Æx½û"’zWÍÚ]¹Œ‰\dJQù£wåxÚö$²J&#¼öÀ*€©\0&£Iשùàœ›»¼LÊìë‡nLÏ¿yºó;ºâ§sÑÇT-ž,S9º&åjç.³×E3ݘ¤Ýù-~‘|K«}L"ˆ)Ú¿íÏ^Õ˜ì§FÛJòÛ÷úÉ»r2+~go}ˆšŒñ–~LÕÒ€1ÙööÒ1ÉGïÝÔØ©hWÙ5Öݘä9â·Ìv~VÍ*ì:Né.X.“àå.ÈLt³ÿ—³»ÊÞ(š~è&ÀÔîüµÝ2²äˆ«}Lbd+%PûqíJÊË—×@ Ž)á“sådVüŽ$„÷–ÖºÕÒhOà÷$ð™{í;í*{£Æú¡›ÓsÄo™¶=1žÑ ÍT ÆT- “oúßSÊ7–ry™”ÙEÓݘÚßÞc»©ìîù¼ê.àŽº¶ó#(·+^Ô˜’æÔ-âG,eÚöÄÊŒìh*4¦ji4»0è¥1@º¦ËˤÌÞ¨±~è&Àôñ[fÅo%©îvĀŸ¦jiÀ˜ðÛó›…în~Ë©hWÙEÓݘÚßÂ鸛X—OålËêc‡Ñ¿‡ë}L â§„ö‘|˜fÅo«{f©ñGûÕ~Sµ4bL™.VN>×䦯NE»ÊÞ¨±~è&Àôñ[fÅoŸ''‹­\µ4`Lö}xkLöÔ¾¹Ä+§¢]eoM?t`jw~KôqÖì÷ûT—,ç`;ÀàB^eLrv[%û¢}Òó[¦Åoôîœüœòçï^1&ýÃìB–›S9¹í2{£Æú¡›ÓsÄo™öüVû8 Ÿ¬UœÊUKÆduòîüίçN£hÒeä]f¯‹fº0¥vç·DŒH­Ø—Oå"²mÃì¥VèÖ‹1y§@H‘|RcJÓß¾Go€\Sµ4`Lg¼“„»»Ú¹Ëìë‡îLé9âwš¿Q’ûr°Oá.†TKÆ”ÒÛ]P‚„)Šv•½Q4ýÐM€é¦ó;úæ 2#NË“÷ h:ÚÆózçwL¾—³· Hü0ÍŠßÆß’¨f†T ¼¨—FÓž5|3&Íá¦ÆNE»ÊÞ¨±~è&Àôñ;MŠß¶ÏðêOÑ÷Ieó[¹4`L~ïôüm/oNå}µ³7Цº 0Ýt~Û³=#ÙKÞE±È˜zÇ€¼$\ôcò+)€d œ²|˜fÅoõ‡ ù­äòÚS¹4`LÞy1&Š|Wc§¢]eoÔX?t`zŽø¦Åo‚ä‚ú3¶Ð˜Ê¥cÒtyåˆwRÝÍ¥h—ÙEÓݘÚßéè!6æb\¹U¯Û>l·dÏñUÆۆć¤Qødçwšxi¬€ÞÎ^\{ª–ŒIÂŘì…w5vM±,³7j¬º 0=GüNÓßÈØbL©¦jiÀ˜R†«ÇDBÀñ;]íÜeöFÑôC7¦vç·í9 ˜ŒðˆB^uHnmÅc6xZ&ïcJ`ŒÉ]û•ñ“#ÂÓ´ç7°ñ7ÛbÆX¶ TK£Ù…Иäv }ºŒ¼Ëìë‡nLϿӬø$SVû¦<)~g@û9Q¶ß©¸Y- \R}ðúŘ|FÕMůvöFõC÷¦üñ;ÏŠßÉuj µÇ…–§råÒˆ1Å÷ïèÞwÀt*ÚUöFÑôC7¦vç·èT&Žš2®z~Ñ‚ˆ„à¬kµÉÞ)ŽèC>_ö“À4+~û|`‰ñôøã0‚riÀ˜@ûó;Ç»­\>í*{£Æú¡›ÓsÄï<+~ÛcB‰1Å)¶rõÒˆ1ñ4&« ›¢¡¯vöFÑôC7¦vç·¹cÇÒxtQ¬1&{q7×Uɲʘbtš&~e.Ð'Oåò¬ç7ø½:oÚv§á‚1•KÆDÞ½rö+Ü4ñæÓÈ»ÊÞ¨±~è&Àôñ;ÏŠßö\ö¯;ÅcÙÏvriÀ˜Ó›1%Ä»¢9í*{£hú¡›S³óûn1¡®¬ÁëÅÅ;½EbÕÉïÈ”»;¶àGi¶óÛþo­òcÛª©\Í.Ô÷ìBŽrg—Ïvî*{£Æú¡›ÓsÄï<)~ûq¶ÛûdäPvå–KÆ$öŠëif›ˆ;Æ”¿ÚÙEÓݘšßc"7j¡¨yŶÎgÅ2¨‹½kŒ Á ƒäWÔÇ€iZü&{¼$ÔP0¦ziÀ˜Òõ=ðI<ùîä7_Šv™½QcýÐM€é9âwž¿!gŒÉžî¹ôc*—FŒ‰ù›1½é1ÑðÕÎ^Í t`Òfç·ÛÃ¥D.Ä c\dLÑÇÅUƒ¬Ùžø$ãIÆ•üö?|TcÒyÏoDIŒD–w媥ÑìÂ×fþ¨1Hx£cêÛÈ»ÈÞ¨±~èÀ¤Ï¿uVü¶ïN°¯;‘÷Ìü¦jiȘøºùÍÞÆsS4§¢]eoM?t`jv~CD´7„œ¸,ÓëÅê÷Jݸ Wû˜ìÁŸ-®Ønç“À4+~ƒßA“H1Å’1UK#Æ„ù]c 醕ë©hWÙ5Öݘž#~ë¬í «ØÎÏ6ï `*—FßøÍ˜|HåMÑÐW;{£hú¡›S³óÛÍNâÑjùµK¼¯³ˆÁJNW“-ö¼þqð'5&íüN è¸ø˜ª¥c’$oÏ/#Ñ7wåôl箲7j¬º 0=GüÖIñ[} Š_DÓ ¯ziØÇ$שk¼¦—¢]goM?t`jv~C Ì™1ÄUÉ')GP£ˆÀ°ê.ýˆÀŸÞ_ùIw¿>kv ™ËvriÀ˜ü¸÷ª±ûS9=í*{£Æú¡›ÓsÄoíüòmŸ«˜´¸.P-õŸf¾;¿c 7^9z¶sWÙEÓݘšßÀvŒJœ8-ö1Ù‹ ]|~¨7­.øòŒIí'ˆ³}Ô(N§mO˜ÉïûìbJJµ4bL!ñYcVã·Àty™”Ù5Öݘž#~ë´øí3~b$å$Þr©ÿ4cw%=Ÿfâã,šEcϹ¯vöªhF¡[×Ý‹1eͪF\r¢Õ¹röWÚ®)y[Íê”ï5P÷úDd8š >LçÇ3®±¤¶ësR0ÄrA¹4Ô˜¾OåÜ£ó¦ÆNE»ÊÞ¨±~èÀÄá1â÷ù~‹&‹[KŠb±•«—FŒ ½Ó‰‡SÑ®²7Цº 05;¿!$IÉ»¢{"®2¦”¢Úß­ÉHÁÒVîVë¶B9åÄ/ÃðÓtç7û@áldª­\¹4:•þÖ˜àÆÁÂvÏ_íìë‡nL¿Ï÷{¢hòÑO­ät¤xšUKÆ”ß~L áŽ1]íÜeöFÑôC7¦fç7D>œGì-Qû­žÊù$cߺFZº’â½í{1ؾ'|Pü>?ž™KѸ#€PÔX¹4`LŠçˆ0{bŒm¹€Ãeä]foÔX?t`zŒø}¾ßã¢É§2c.î1ÕKC‰¿“'ÚEs¶sWÙEÓݘÚßÑqÚ ~2§°ª1Ù‹³&ïøó¹‹ŒÉ^„ƳüJµm? L³âw–£ËT|wZŽ/—ŒIÓÛó‹ozå8œŠv•½QcýÐM€é1â÷ù~‹Æ¾ûÞ³HÆ¢Á²ZiLô>•scÙ»­Ü©hWÙEÓݘÚßF\²qðá®+˜àõâ¶k!£L™V5&@ŸFR¶­ä'iVüÆh¿“f-¯=ÕKƒ“ßx¡·!éQ‡SÑ®²7j¬º 0=Fü>ßñù~#û5¡¢hª¥c²ïâµÿ·Ç´¯ ¯újg¯‹fº0Åvç7øV,¨’áêjç7x RÖ`_—¸Ö.àŒ)‰Aaµ÷-|Rü޳â7'ÃY?ŽÏ±Ô˜ª¥A¯\Ôøî•cvKŠ±Ì¯vöFõC÷¦øñ;ΊßàRˆ›ÞãÏ~žÊ•K#Æ„owAqùõ¦hNE»ÊÞ(š~è&ÀÔîü4²$Ç$%ÔÕS9ûŠ€úV€¼:%Å0)*ùÏûùìü>?žq%H#©mÊ ©ZM{|Ï.äÄív«Ä¯vöFõC7¦çˆßq~ॠRÈs媥câ|Ýcˆw'&ñ=ŲÈÞ(š~è&ÀÔîü6pH ™Ù¾Kaµó;*Çc0,ÇœW§¤(!’Q?9%åüxÆ5f{RCYËãùò˜ª¥Æn:¿\µ³7j¬º 0=GüŽÓ¶'@Þ%”Ù½É~Sµ4:•K|yå0Ñø//“2{£hú¡›S»ó;º;nŠ@Þz³Ê˜|¼J‘À­Ó—Äïã‹* §øI)Nw~g÷¥JÁp¶˜ÄS/ ¿ojßÓÕÎ]foÔX?t`zŽø§Åïœ"f å0ÂziĘR¾~Gp'~ÇKÑ.³7Цº 0µ;¿Áéë Z–€éõâ‚=ÀsR]¿ÿ|œ|û ¦Q5ÁôÁI¼çÇ3®±d_v—–ùgo½4šöLß³ …n<¿ [¾ÚÙ5Öݘž#~ÇÙÎob ¬ö¥‡‹ÎïjiȘ„/Æä–í¢³»Ê^Í t`‚vç·w_ !Æã_ˌɭ•_ë5Æ”È9šqµŸ¿aÖó;‰þô¹ÄÅÀ‹jiÀ˜Œ2_½rÌ9ÝhLpyWÙ5Öݘà9â7,Øžd#¯’¼Áº¦rix*¾§¤Ü #`øö2ù™½Q4ýÐM€©Ýù FXÜ 4ÉÚ%Þ׋)¡§\u°ô†ñ@mãð“[9˜¿ÅÇ "¡PÄÒÁ²\0&ƒë®§ÛÎo8í*{£Æú¡›ÓsÄo˜îüvÛÿʧ—*ô£+·X1&9.Už}L7žß W;w™½Q4ýÐM€©Ýù )ùÖV­ØýL`ñT.ySD¿»µz*}:KÔHNº> LÓßrH¨jSLÕÒ€1 }» XYÜÈpµs—Ù5Öݘž#~ìøí–Ôö¥Oîwø³+·^v~¿g~ÙÆëî(NE»ÊÞ(š~è&ÀÔîüŸ»U“b ¥+)Ç‹9‚·nKÆk‚×]¹˜RÈYXù“wå`ÚóÛç#¨¨ÿU¥ƒe¹4`LB|3¦û‡ßeä]foÔX?t`zŽø Óâ·ø½jµ‡;&^õÒ€1a|» JLp·•»í2{£hú¡›Óç·’û´QHQWL(O‰2Qñ&ÉÅS9cKF1²¢Ï½ú ÓùñŒk,¹¿B–HB å©\¹4bLIß}L¶õºcL§¢]eoÔX?t`zŽø ³â·ˆ} 1×ÖºÕÒHc"¹&Xˆ³âvÑà©hWÙ뢄îLØîüŽäC]5j²mÕª»€½˜Áí|ºñb%´§?£cûà0‚ó㙨±È‰m/’éâ>fµ4bLøî•3Æ”oX9^Šv™½QcýÐ=€ Ÿ#~ã¬øIܳ©xY-4&Ho?¦pK³ñT´«ì¢é‡nL7žß‚îmï–J޸Ș„‚¸Ç éY=•ScJörAû×Gû˜pVüV >P"Š[ÀüdLÕÒÐW>¼'ñänX9âW;{£Æú¡›ÓsÄoœíü€Š!%¿rZœÊUK#)ÓûÄD_c[Es¶sWÙEÓݘÚß`lc1@^ =p¾Xb$:ú ÖSp¾””•ä“Ίßì×Ú|[*éøÑÇT, }åÓå. AÒMƒ%òW;{£Æú¡›ÓsÄoœ¿…|–øuûÃZ·Xº Ä÷ÓL#ÜÑlùjgoM?t`ºéü>œl?ÅËwå “ÜŽfƒÅS¹¨ÁhÛžâGiºó;Ù/dlÄMµŠËjiÀ˜’±Àï»sIÅ«»ÌÞ¨±~è&Àôñç^fÑàô?„’f—KÃ>&}Ÿ˜hNwÓ{Še‘½Q4ýÐM€©ÝùÕŸÀ9ØØóëwå²Ú–áÚ%Þc’A$§NüQiVü¶=¥Ú¦–ÜQ»ðcª–FŒ)½O~1݉ßx*ÚUöFõC7¦çˆß8+~£±tî‚–wåÊ¥¡»@þÃþnÜéT´«ìuÑ B÷&ºéü¶§ØnÐõ‹UÆäÓ„„\’]:Ò{9X"ù|4a÷õýä%^šxi{R¿Œ¦¥Kjµ4šÄ#ß÷1âÍVŽ®)–eöFõC÷&zŽøMÓß”Œú§`›‡ªó»\iL‚o)kº&éjç.³7Цº 0µ;¿]EM1H  iõ®œ­ ñ°^¦Ã—WÂáô@n7÷I`š¿YHýöŸØ.©^. 5¦üÍÊSºaLt*ÚUöFõC7¦çˆß4/~3)‹h¬Äïbièùß]¹šîÜè­hÙEÓݘn<¿“ïfý-qçÍUÆ”CŒ>² €xi|ÓáÇ\¡"¬þI`šxI)úõ?o’-5¦riÀ˜Ô6ߌ)ßÓ5ŲÌÞ¨±~è&Àôñ›¦Åo%é—¶m«TΕ+—FŒé5*àŘ(ßhLt)ÚeöFÑôC7¦ÏoIY᦮˜PžŒ)‡œü^ÃjçwôKvÀvúѭܬøÍÙ]p cù5JàŒ©\1&N×÷€ýšôMŠv•½QcýÐM€é9â7Ív~{crRtZ\ø1×Kã»rá›1Ý]I¡³»ÊÞ(š~è&ÀtÓùÉ8 ù$¦–,_/– â{²–Œâìíb{Mòn5÷I`š¿íO#oÊrþÙ.P/NåH.Éßš›K¼¤_íìë‡nLÏ¿iÚöDØû]ɶ•íI¹4:•Ó?ô1½æ™6І//“2{]4ƒÐ=€‰Ûßöüu©ž’Ûo¯NI¯E|2Ý*c²]$¯È=Ò?L<=ð’c4B­ªI¼ÅÒˆ1Axϕ˷מøšbYfoÔX?t`âçˆß<ïùÍ>G£”3¿ê¥!cJ—“Ñl¹1ñâ·‘w‘½Q4ýÐM€©Ýùñƒ—ÉèÞò©œ½8ç<Æ ­‰ßá/9iˆ œb:lOnJé÷À4+~£‘+¿V”„rJJ¹4Ò˜ÞŒI5ÜÈ|*ÚUöFõC7¦çˆß<+~{ÿad¿AQ˜xUKÆ„üöcöè›æ7>í*{£hú¡›ÓMç·Ê±1H>ûs¹ó[ÁÐØ{0Ö“÷T¨}½¢PäOÓ¤ømS™‘üsäÒ%µZ0¦”ñºÉ)ßÊ1µ³7j¬º 0=GüæYñÉ>åÿ?w_›ìÌ­j=žý#§$@H àÎJÚÝíXߪTW©:¹IÎû‚yö¶ñêÅ{HçI“™FŒIø¾ù-œZÀÄõ蕤é»nLõÎoB±Æ+Ó™âÊ2]8_LÊzÆ•:ð8•Sj úº˜l”< L³â·&ìðâÓ…ôïR.7ÓgÓɘ¤L§¢]D¯äXßu`zøfÅo¥!ØÛ³yL…i¤1¹pM° )„Fƒe8í"z%iú®›S½ó›¢B38A§/ÜÃ…óÅâ%EBG+7€1Ù5eL¶¤EÒ!»ÓSÀ4=öD ´ $}>ö$7 “¾)ß™_­»f™äÑ+9ÖwݘÞ#~‡YñÛ±‹În£%É÷ʦ¡Æt÷˜Ø]¹F»¿zô2i®{×;¿Lµ˜¢@ȼ̘‚äeJ ŽÍ³KÀ”´¤Öç³-(?†ú>L<+~Ç`½¦Jál×ML¹icî&ëcj6ñò©hÑ+9Öwݘø=â7O‹ßœRälº`iv~ÇûÄÄ®T4’æR´ó蕤é»nLõÎoö !")üœ­0&öè*ëôú_m}ïƒr.¥kàŸ,åxVüެ©¡E)1J6Z·0r Ý=]à\°Z˱SÑ.¢Wr¬ïº 0½GüæYñ[«kŽâ½ÝcÏJ¹Â4º+ßýJ6h6ŸŠv½’4}×M€©ÞùÍ "xŒvùx‘1é‹SŒVÚz¹Åv›A¬€¦<Í8Û“À4ÛùMÊy;† ?Ú/0¦QŽI¼¶¤°j´¤ðÙÎ]D¯äXßu`zøÍÓâ·â@\ .›.X˜†O3º»r#†ÆK¾íýR±%µ0NLïé‚ ­æ·x+ÚYôJÒô]7¦zç·HZÊy";XcLúbRdgr+KéŒ1±Ø2uë€òT{ ˜¦Åo›&’l…gÊÇž¦1+ÿî.nÓ¥hçÑ+9ÖwݘÞ#~Çiñ[‚"&9;•+Lƒ§™óxkLvàÝHšKÑΣW’¦ïº 0Õ;¿…­I&–'XšÖÁÆÄ…ÀÇ•Å#»díÑé=Lóâ7ÚwÞúÜÜo)WšF½ráÞÄ{̬j䨭hgÑ+9ÖwݘÞ#~ÇYñ½Kx,œ°Kð?ÀT˜FŒÉ _Œ)pkEx<í"z%iú®›S½ó[Äf)ÉsäxUcÒ=”(v½d±)*½Ô¯¯¸è”e> LÓ3¿)•ùaty»@n2¦ïîB'±qò¯AÞyôJŽõ]7¦÷ˆßqVü¶§³;:Œ•g¥\nvå†/còÔ¸`OE»ˆ^Iš¾ë&ÀTíüF[%plO´á‹ßöbJv¢ÇÖ¬³Æ˜Dߦ`oV2ÚõdSœžùLÂ‰è•æ›xsÓˆ1^,Ù{×*å®AÞyôJŽõ]7¦÷ˆßqVüÖB]ɾ!ïcÊM£{L|–rš@ÔœùNE»ˆ^&ÍÀu`JÕÎoôh¸àˆ•í­ôHÂùâãú¯Ýh ‹WR’$­©=;»ñ|¬ñ} ˜ÒôØвֳÒ@Î, ÓèvA¼ïcÚìâ0¥k–I½’c}×=€)½GüNÓ /SJD O¢@ÙÍïÂ4œ•s^°´£!h˜¤k‹e½’4}×M€©ÚùZÖ*.Ùhp¸8óm¯iggE‹“]($›”ÎñÉv4=óEÝ} œiL…it*ç÷ó;µ.ñ¦kw½’c}×M€é=âwš¿ÁNœ­‚|}sam°_ ƒo”r‰þêÑ+IÓwݘªßhƒZ£-*IäÖÄïÏ‹™ V$HZ\F(FÐ R‰š§'iVüN"lG)_ßT˜FŒ)Ñ­1y”+?í"z%Çú®›Ó{Äï4+~{o‹Èˆ“ËiviÍʹ€É©1Z7Šv½’4}×M€©ÚùvYÝés“Bôâ<&{1y[ ' +› ,ibd”˜|žœÇ”fÅokŒ ö ¦ÏÜSn1& ÷^9Øbå§¢]D¯äXßu`zøfÅoÖäÕoÛqiÖ•[˜F{åÿµ%ÅIkKj:í"z%iú®›SµóõÑ$DÏvÚ³Ô`ùy1ÛPk—E‰µŒ‹@>ØÅçGû˜Ò¬ømØëèsÆ”›ŒéX.|kL­M<éT´‹è•ë»nLï¿Ó¬øµjw.&0M㘠Ӏ11};¿pƒ1É©hÑˤ¸îLRíüF VÂâƒxEÓ¥ËÏ‹Ñ;ñìâjç·-0ñÛI’ô¤ø-³â7Ù>áÄè|’üonÊ}.‡ŸSR}㮜œŠv½’c}×=€IÞ#~Ë´øm£Ž#9NÙ©\am°º;¿AZÀt)ÚyôJÒô]7¦jç·>ÙÅÔgˆ6þ|±éx±PðÞ®â.jL66*"qLoOÓ¤ølE³M µ;2Ùí‚Â4êc r瘦[Ccü«G¯äXßu`zø-³â7ø`C6³ ¥iĘ‚¿NL‚KÜh°”SÑ.¢W’¦ïº 0U;¿µÓ*Ž xˆ¼¬1é‹m‹/Ù‘Xxñ1ÉFÄ)—`-$Ý“À4+~‹±7­‘8þ]C_šFŒ‰Â—1Al°È©hÑ+9ÖwݘÞ#~Ëtçw &ÝD0fO³Â4`Lú‡ÞO3ç[wåäjçΣW’¦ïº 0U;¿] 6’IZqf‘1é‹Ù-è‘WGë²ñ,±^(ÄCcâ§€iVü&ëÒ§JÐçJL…iØÇä¾ßÔjâ•SÑ.¢Wr¬ïº 0½Gü–YñÛ&ЉM%sySn1&üîü²)ü¤9í"z%iú®›S½ó¬^H‚éâ]¹ãÅv (‘_h‚ú Šs¨Uµ8¶ýMO^I‘é™ßŽô+}J Ùú¦Â4œÇ”î¹òÒ¼Ä+× ï¦óAq¹iÀ˜‚¤ëSp®ÑùÍþêÑ+IÓwݘêßcd¦ÓÒŠðëÅAàR\{B¤¨J×ôFð(0ÍŠßú”b&€Îg¬¼0 ïÊÝßvªÐʱSÑ.¢Wr¬ïº 0½Fü>ßñ\RzƒJþó“Ü4`Läã5ó[k‰æÓìše’G¯$Mßu`ªw~£>ÎÑzöl»ù²Æ¤/ÖwSi¢–KÀd¤"¢í Šä"ãƒWRÎgœcÑî“R-m1­[˜F}LÁÝ3¿]Šõv} üÕ£Wr¬ïº 0½Fü>ßïqÒ$Êb½C;øÊ®¤¦c‚׬bjô1±ã¿zôJÒô]7¦zç79a´†bJ«§röb}vÛªÄÅõM6å½>4=ÙÇt~<ã³õxQ S/@Y¯\i0&»xæƒ÷­‡ß¥hçÑ+9Öwݘ^#~Ÿï÷8i¬´æh·«0Æ_a²4 ^{åìžX‹f_[,ó蕤é»nL­ÎïI¢Â©„•ënp½X” FÌ‹“ÖqÁëåCBpŽ=9?ž‰#C. ±Ñù\ÇÌM#ÆäàÒ1ÙùF»sw½’c}×M€é5â÷ù~Ï$€mºÕÇDÌŦcr®S9ÒoF}‚%û[Ñ΢—I3pݘ|½ó­W1E´å®«wå‚ýöè‚]˜[ÇÌ dMÿ…ñIÆägÅï oÓzÜ.¤e›x Óˆ1á·É‡cò§¢]D¯äXßu`òï¿ýôÌo‚C’„c*LÆäÂÝÇD¶¾‘4× ïØ(ÉÕyLúbÚ™ÀÑÊRºƒ1E“–˜´$ágÅo?)~ëOƒú“EÚ_`*M£>¦äï“ßDTï•Shþ«G¯äXßu`zøí§ÇžØc"°õËó'ÿ4¹©ÿ4C ÷–‚ -š}Í2É£W’¦ïº 0Õ;¿•ðh ê’–¥é¸p½ØV0£~aÇž0p$s žœ`y~<ã‹ì*Î*'LÇ,M#Æäï –ša­S9*ÚEôJŽõ]7¦÷ˆß~ºó›ØN¦µvà¼] 0õŸf¨á>•;Ÿlµ¤¹Ú¹ó蕤é»nLõÎoló')(cZ¾+g/¦äDlHî"cJBDïìðŸ¼Ä{~<ã‹ú.ˆ°Ôr±‰77 ïÊý‹1 ¶XùÙÎ]D¯äXßu`zøígÅoã9Ö[&˜-#(L#Æäýµ%•ÀaãiLšëÀõÎïc,H$Š&·­N8†¡DO+ÃÆ$ZEk‡v#•ž,å`RüNúë(  -zÏÅ•¦Ñ&žtçXÐZ·•cþ¯½’c}×=€ Þ#~ìø­$l†õ÷g}L…iĘüý4SqS9€¿zôJÒô]7¦zç·#ÃVX²N«[RìÞab?Ånu´.8;c"°#ƒ'§ œÏ8Ç¢PFLZ‹Ç‹ß¹ixWî>ù & ¹.E;^ɱ¾ë&Àôñ¦g~£-±ÖLJìSi0¦ÈwW.9l,#d¸yçÑ+IÓwݘªß tÇváZ=qIü>_L.Y·i*kŒ)±÷¶Ø.òÆ/ñžÏ8Çl¤ˆ·%\¶š8ß’’›Fwå¾}L!úã«åØw–ÉoôJŽõ]7¦÷ˆß0+~Ûv[ ‰•cAÞü–›Œ‰‰®ŸÑVN4ê8í"z%iú®›Sµó[ž­Cdk=Üâ–”ãÅM ‹Ó´v jeíâ“£uÏgœcѺâ14|¦1¦Ñ¶ç”î»rœZ· àT´‹è•ë»nLï¿aRüŽ)$»mìo)WšŒ‰¯æ·ÞbL鯽’4}×M€©Úù ‚¨(  ågpËŒ í‚„D-ÇüÚÌogÀäôõlœÉ¥G5¦é±'ú ²r@¿'¿¥iƾp‹1]³Lòè•ë»nLï¿aVüfäèÅø+`Ƙ Ó€1Ã5+YB£ÇOE»ˆ^&ÍÀu`Âjç·),YWhXš\ç‹cÓ‰ôw_íctlïZ[ê“Óp¶óœrGÉnðeSa1&oƤT´Á˜ðlç.¢Wr¬ïº0á{Äoœ¿9T"ÂìK2`ÊMÆ”Ø\Œ)~ÎÏjIs*ÚEôJÒô]7¦jç7°–žÑyk)V€YdLúb;¼¶=ß¶kmº@4f©/ôì½²”Ãé™ßZØëSËé·ŸóËÜ4š+OáÒ1íúHCüÆkw½’c}×M€é=â7NÏüÖÿ‹¨ô߃ËNå Óˆ1%ºú˜0:iåâ5È;^Iš¾ë&ÀTíüVl‚ãZ¨í:YdLúb­Å¢¾ia˜Ó1É7jU‚-ô}˜¦^z;^´ÕƝ/L£mÏÞ_߃ Ñzø][,óè•ë»nLï¿qRüŽ’'”!Ù2ÂÂ4`Lt ñ:„phˆßÈõ蕤é»nLÕÎoÅ­<Å¥ˆ+#•NƤ_‘,ZÉÁ"cB"TŠéÁöƒò£À4)~'gMSb; Èîc¦Ñ¶çϾƒ1Ñg”s-Çâ_=z%Çú®›Ó{ÄoœíüŽàM¢Â~…ÉÒ4`L€îfL­ –x¶sÑ+IÓwݘªßŠÑhWü„\\\ßôy1ƒ8ð´š[œù9¢-áKIÌŸ¦Yñ;$LÂÁq$ÉOårÓˆ1!Ý3¿1`}>þêÑ+9ÖwݘÞ#~ã¤ø­l„쉭hÈSf0&û>]ŒÉ®bÔ“†Ü_=z™4×=€‰ªß¢þ­¹î”0ÁR)÷y±>Z"² ¡^dL>jåkä8oGzô0ÑôÌo'1Ø•³òÂ4bLnƤoO˜èäG¯äXßu`¢÷ˆß4=ö|®fe§r…iÀ˜œøkVB„ÆØºf™äÑ+IÓwݘªßL½NÖ±î?+–S;ÌåˆKÓqíËkÅÞm·ú“wåh¶óm @dœµ ¦cŠá¾+‡‰ít¶sÑ+9ÖwݘÞ#~Ó¬ø‰ƒ²~­“’ËïÊå¦crn (µ’æT´‹è•¤é»nLõÎo"Çñv\k°ü¼Ø–U)arnµ]•²v*'ÇHÑiVü¶m-È•í`Ì€©06ñ\ />#PZ¿ðW^ɱ¾ë&Àôñ›f;¿£U>Ø6ß’R˜FŒ‰܌ɥ†ÆDg;w½’4}×M€©Þùöðõ¤ù6vs1¡mÊÄc®‡-¬ZbLH$…$ðäh]šíüŽÁNâ ú\.(LƤ¿Û=%UB«‰—Îvî"z%Çú®›Ó{Äoš¿õcHÞ”íè˜ Óˆ1}Fºs3ZKcJõ蕤é»nLõÎoƒéDHЍŸCûƄΦ)xEµàaq¯–Ñ.òz åü1`š¿9rÐ7$:fam{vwŽ)0µFëЩhÑ+9ÖwݘÞ#~Ó´ø­4‡QĆ÷äâwnê?Í@"Ä‹1yH š.E;^&ÍÀu` õÎo…i žSZ­ûyq 6:Ö¬lË<®¤€ÍÓ'f+}éIÆfÅovŽŽÖj D0å¦ÑîB¢‹•“]Rnä˜ÿ«G¯äXßu` ï¿Ã¬ø­u;Ìr©0õŸf¾ÓÐnÅ4’æT´‹è•¤é»nLõÎop¤9®ãDÿYdLúb€˜ÀÊÌ”cì Gej¦oy›¯÷$0M‹ßú«@B¶iÿù ¸Ü4`L6ÂâbLQkè9\Šv½’c}×M€é=âw˜{b c•Èz»ðñ L…iĘ|ºê´km¤¹f™äÑ+IÓwݘêßĶ(QLÊõ–,?/Vnv‚-k}Lúv}.})cUpˆß<üïÀ4Ýù­ø,vƨ¬7­[˜F» ƒÜ3¿lÞd#Ç®vî KÒ?ÔcÂô$0ÍŠßúãØø– 0ß’R˜F» ?ë(?» 5®¤ð©hÑ+9ÖwݘÞ#~óôØg› =€5¿æ¥\f0&¾.ñZY‡M`ºf™äÑ+IÓwݘªß^ô²Q­ŽOåìÅÎ)Ñ‚ °‚jcâ`ÔÒf8NOjL<+~3q¯ùìŽÌo»@n1&8/ñþs¬¡oô1ñ©hÑ+9ÖwݘÞ#~ó¬ø-`;‘üÙºö/`*LÆ>{¾ÆÄÂ-š}*ÚEôJÒô]7¦jç·OZO¥zdíH‹“½XÉŠ]“XÙ/~0&kLúv!êŸîŸ¦é…—V…#Ú=›lJjimâùÌ`úì.ŒÔИøÚb™G¯äXßu`zøÍ³â·ÖH,)Åäâq%ògVNf2¦tM0ÆÔÒ˜Ò_=z%iú®›SµóÛ~è@>é^hµÉ^ŒÀ:’ÅéKŽ^yÖG?MPÓtç7y;¥5†|onÜ.Há{*g¯näØÕÎG¯äXßu`zøÍÓ3¿ƒ–ÕÊEP(ä£usÓˆ1…x=Í€ƒoô1Åkw½LšëÀ«ßþ¸Ûç´0P¢·r«Î£Ííô×7Ù~Pà¡•`rð$cг߶®4:§õ}>)7 SDß•säŒ)žíÜEôJŽõ]÷¦øñ;NŠß‘C´ ÜR(hvn0¦¾“þ§Y„¿zôJÒô]7¦jç··Í Ê!õ§¿‚-ðyq…cÛH°¼ŒÀ[c§'[ûæà8Ò{ ˜¦ÅoçÉë/8A¶‰§0“ƒ[cÒ*·!ÄKÑΣWr¬ïº 0½GüŽÓâ·~ÝÁÖ‚‹¿O³Ò4`Läî t ¨%Í¥hçÑ+IÓwݘªßžC² âM¿^œÇd/Ö÷Ò(2Éâ<&#ƒr[gçXž<•‹³â7¸‚Ç÷ž3`*L#ÆÄáš`Iv.ØÈ±SÑ.¢Wr¬ïº 0½GüŽÓ /cŒõƒ (¦Ü4`LDxw~[íÕHšk‹e½’4}×M€©ÚùíÙ&e>Ì´ÜǤ/öIȹxe41&p ÁKøäÉS¹8+~#`²9ä`7š©06ñÜ›xRSüާ¢]D¯äXßu`zø§g~c„tŒ|à˜_âÍM#ÆÄríü‚@­“x òΣW’¦ïº 0U;¿=t‰(¸Õ™ßöbú¤èq­]À.Ú±çèl »øä]¹8+~S ÖEhãX~©06ñ¸t}¹uÀOE»ˆ^ɱ¾ë&Àôñ;ΊßÇ2êà1å;¿ ÓHcòéš`iw-÷˜’û«G/“fàº0¥zç·b©–rAÐ&,nâµ; HìíÌ‘1[ÒÇ‚‹Þ<Ùù¦g~+µ±•-¢¼$¿Ä››ŒÉFè]Œ)Dn<üÒ5È;^ɱ¾ëÀ”Þ#~§Yñ[ØÙ)ŽòW¤\˜ÌM#Æý5 J ˜à¯½’4}×M€©Þù­Ø¢•- :,N°ëK‰—u)D-x(ií‹!< L³âwH!Ú:‰¨EyƘ Ó1ݧrÈÁµ€éT´‹è•ë»nLï¿Ó¬ø\Ô²+‰>Ö³Aq¥iÀ˜PÎK¼GY×ZßœNE»ˆ^Iš¾ë&ÀTïüFç]` o‹[ícBg¿qtúü†•)scbŠÌv¸tÌÖ{˜fÅï¨`é¬áÓË Óˆ1ù{¯œÂnkº@:í"z%Çú®›Ó{Äï4+~[sKѧ,0å¦cÂänÆD(>¦t*ÚEôJÒô]7¦zç7(šj’§h+u7ñÚ‹“k±F¨UÉZÈÈÊ@öOžÊ¥ù™ßE+S%¼!¿ Óhwa¸§ Ø‹מÒ=È;‹^ɱ¾ë&Àôñ;ÍŠßvÁÍŽIm lÞ`™›FŒ‰ïé‚@Ф٧¢]D¯$Mßu`ªw~Û  ¿ ~•1é÷Än¥ØìKEûEÆÛ¥gFŠødƒeš¿£(‰;P£|‚ea0&{J]Œ‰\kEx:í"z%Çú®›Ó{Äï4+~#†cJ´ÖJYIi1¦ éfL¾Õ`)§¢]D/“fàº0I½óûP¿žm!Þ"cò¨a£5ÕØ]àUÉi Ê–¬Á’&™¿%(çµA¤Éfýþ꘹iÀ˜¼òÈ‹1ÙžªFŽŠv½’c}×=€IÞ#~ˬø­fo…’ÇgÂda0&¼Oåì\·‘4§¢]D¯$Mßu`ªw~{ÐúÓ‹þíÝÚú¦Ï‹›¸Z·Øðý5Ædí¨’DÁÉ&Í= L“âwò.;!Åèl‚Eam{wï. .4“|í2z%Çú®›Ó{Äo™¿Õ vî ëc*LÆäoÉU7’æT´‹è•¤é»nLõÎo[ìê›lhÐÊt\ø¼ØE¦pÜÄõ«[WË„l;ăÀ4ßùí#믣—߇_aiLpŸü¢Í.näØÝÎE¯äXßu`zø-“âw´?‚¬$6_xYšFŒ îú€›ÀÄõ蕤é»nLÕÎoƒQl™Nðð˘Dô•"vÛ|È؃ÿÐq­ýëI`š¿“Ý% èƒåÙ©\aiLn ­F®çØ©hÑ+9ÖwݘÞ#~ˬøm Ì¢Íe¥æ¿Œ©0“÷<&ÿOQKšSÑ.¢W’¦ïº 0U;¿•*iy.1ê?” “FÈ yï(Äa5–w~O‘@«žð쩜Lw~³M ÷A”ñæËrÓHc‚pÝÇDë]mäØÕÎG¯äXßu`zø-³âw4Ý%%Ÿ‰ß…iÀ˜¼Výc²{¨Õ¤‰îT´‹èEÒŒ\·¦X~tƘ’‰CZ(g‚†¼å—1é‹ÑÄÛ†p­È“C úè×g¿×‚ð9`:?žqŽé—^‘6RIL90e¦Aމœkè ¤˜[9æÿêÑ+9Öwݘ¢{ø}¾ßã¤Ñ'3iÍ¡6‡ìº@i1¦k¡;V6Öivtç ï"z%iú®›Sµó;ÚÄ1¶{§?üpWÉoÒØYœ2D ^9S\@µc“¾˜£5~'‹ò$0Ív~“ÖµÊyS³mÏ…i´»ðs9ü³»0I•Gw¶sÑ+9Öwݘ^#~Ÿï÷8i]Ï6îÈýÖÿ¥iĘ"Ýßv—¢‘4×,“]³r¨1ÁRÄ_=z%iú®›Sµó›Å%;5²3hT¿Ic››¼[kMÆãé¸cŠ!Ù™žMtRl|˜fÅo±¶,ýþR™ÆT˜F» …î“_¡Pט¢;í"z%Çú®›ÓkÄïóý'M²‰îPÿí1[^˜ÆÓ}*çCC˜ŒîT´‹è•¤é»nLÕÎo¶°ÉûLÇs$GÛËç ';…ZcLÖ(èÈi øä–”óãçXDѲ1Æyçwan{ßmÏ­+)ÑŠv½’c}×M€é5â÷ù~“&i­0Ù%FñÙËÂ4Ò˜ïyL¶C¶ž4þT´‹èeÒ \÷&_íüfP–gíD¨ÏZ)g/VºØEýŽ?Ä–Œ1:€”\Bz˜üüÂKB°WdƒâJÓ1ù›•Ëç`¿–c÷Ë,z%Çú®{“øígÅošûÖŠ'Ÿ>ÚSn<ÍúkVŽißõ!^ÑŸŠv½’4}×M€©ÚùÍʃֶ*|¡ƒÏ‹­‰X_Ï!¬1&}³ÂRbÒ?ÜŠÈF*ýw`šžù}¬’ëEÃ|áen1¦Ó͘$µ~× ï¦œ³*0EøI‰¦Çžè›¡ßø@ ™™ŽY˜FŒ ý­1‘H˜èše’G¯äXßu`¢÷ˆß4+~“ÖÖFcõw~¦câ ×Ïh×14›NE»ˆ^Iš¾ë&ÀTíü怊 Pi‹‡ÕyLAé!'‚@¸|‰÷©ïg“Cx²‰fÅoÖ‚Ö†, ò¸âof1& —Ži+‡· ÿêÑ+9ÖwݘÞ#~Ótçw"}@K—ÓìÜ4`LúºOå •4W;w½’4}×M€©ÚùÍÉ®1;"¸x*§/É·l(.ö1ùœ~É‚u F€'iRü¶ñ-Z[Úʘ”­/M#ÆDñÛÇäš¿ðW^ɱ¾ë&Àôñ›fÅoŸ<Ûm’˜3¦Â4`L W‰§æ¬:í"z%iú®›Sµó;†Àl;Êœ-,Y =ðy±=·=;Vê´ØùmÓ|Yœ€ ÷¤øM³â7ò±óÜÙ ’¬©0îÊÜ,ƒ´tL:í"z%Çú®›Ó{Äoš¿c‚x,l×ÿ™Ê¦c"‰×=&¯Ÿn£Ç„NE»ˆ^Iš¾ë&ÀTíü¶D§¼‘Ó1®uqKŠÂºØÛɬuÙò2 Á£CÛ¸Ó“À4-~Û*)2'ùÌïÂ4`LZŸÞŒÉæ©7rìR´óè•ë»nLï¿iVü‰½OúÉŸf¥iÀ˜(ù»Éö{Ô“&œŠv½LšëÀªßŠ¥bÃu)oY»’r¼8BâcSZ¿mY ¥è•g÷$0…éÎoNÎöÜX™”mI)LÆ„!]{å”Jƒ1…«;^ɱ¾ëÀÞ#~‡é™ßΧ_M³|‚ea1¦øÇD„R.\ƒ¼ó蕤é»nLÕÎo»è$Z¤$X*åìÅ,l[Ó’F‹Œ l;¹>l¸@x´)L/¼D—0r¢|ìIa1¦@ßS9 )\[,óè•ë»nLï¿Ãlçw`i–ìPÛgÀT˜FŒ åzšyò­vp¶sÑ+IÓwݘªß œírAp·LÇ‹íÐ:ðqå}‘1!*qu¢lÉ‹t´n˜{’lÍÚøÂâT.7vþkæ7ºÐèü×,“í"z%Çú®›Ó{Äož{­Ú;ï„r)7O後‰±Ñc¯Y&yô2i®{S¬v~'}Žî«@äÖJ¹ãÅžÙš m7Ý0Ù `T®À(v]ïA`гcO¬Rœu1b–c…i4%•仉‡[}LñœeRD¯äXßu`Šï¿ã¬øíĆc‘ín§|}sn1¦àî§*66’æT´‹è•¤é»nLõÎïdkÍA"“ûT+Œ)qb°±ø¶ôrIü>n+_ÂäõKìÒ“¥\œ{è”7ÚÚò_V^š†›x𻻸¡cÆ{–I½’c}×M€é=âwœ¿ÅæiÓ1MÛK½¿ISšF“ L<Ÿf¡•4E»Œ^Iš¾ë&ÀTïüލ?¯MFq«wåôÅ(àƒ îæÕéQߥxßút'K¹8?ó;$eNߊ/#ÈM#Æt #ä3©0vÒ÷>¦Í5mäØÙÎ]D¯äXßu`Jï¿Ó¤ø-Zn þô{] 4 žf¿=&€Ç”ZÒÀ_=z%iú®›SµóÛNú9ê¿ÈóR»Àñb° LÉ%ˆaé¯í•S@"°æ§ðö$0ÍŠßÑÙ½½è¢$Φ ¦Ñ\yák¯Ü1¦‘c§¢]D¯äXßu`zø¦g~;ˆv°l¯ùtÁÜ4Ò˜<\³r<°oô1¥kw½’4}×M€©Úùm}×bíß °$Œ‰HÖÇKZ\nS@fNañQÆ4+~'ô"D—±òÒ4Ò˜à\F`“Ö»;í"z%Çú®›Ó{Äï4½ð’¢uñé÷@ _x™›FŒ)нW\kº@º¶XæÑ+IÓwݘªß‚­Âs¶{Ú¯­o:^l³­“Sl¢°º‰×aŒ6'Žõ3xô®\šîüÆd»¡íè‚óvÜ4Ú]è¿· ”Þ´rìjçΣWr¬ïº 0½GüN³ßÁƸ†$øì(·4 5¦t÷1y‰®Ü”þêÑ+IÓwݘªß¢TIÐæxÐÿµÊ˜ìÉM¼6µº‰7¡¾Ub³bò“À4Ûù8Ø>b­‘BÞÇT˜F›xø” ¬¬ãÖÉo:Û¹‹è•ë»nLï¿ÓôÌo°#mÂmºô/0å¦cÂï&^ŸB£I®AÞyô2i®{“T;¿EIK[RÂck§VOå‚iØAk¹•5¾cB›¢ %- Ÿlé…—Êwãñ/Î×7¦áîB¼çÊ3Q£ó[®-–yôJŽõ]÷&yø-Ó /} àÄÚñ²vÒ4bLïúßsKü–k‹e½’4}×M€©Úù­•”pJ¬ª?÷ªÆ„Ì6ƒ l]UZ<•S®eâ9ÙÀ'Ó¬øH‚Bt$[˜1¦Ü4bLáž. À”Z9v*ÚEôJŽõ]7¦÷ˆß2=öÄÛ"ѧ:S®1å¦ÁÓÌ‹¿OL<¶öÊÉ5Ë$^Iš¾ë&ÀTíü P+O·´è>/Vt±sayº#ê÷ ¸äÉ+)2+~“R@;·àœM(LCÆäï¹òlÝõ õè•ë»nLï¿eZüÖiÛ¬?ƒqÿ L¹ið4³ëÞ7cÂØ81‘KÑΣW’¦ïº 0U;¿Åúbœ=kQ—ÅÙ‹“-pÊ}Vê@K:Z§¼$gBÕ“WRdZüÖç &­Â?ë›2Óˆ1¹x÷1G!µ»í7ÙŽ§™ãÆÂK­0þêÑ+IÓwݘªßÞ,“×R.©TKï@¢þ¾¢Å`šñ±ð21ظpm`уó˜Îgœc‘8ÙJ†Øå+ Ó1Á¿“¯ŸÊ%w òΣWr¬ïº 0½Fü>ßïqÒ$%üèY+k¥ý¹ø›FŒ ðîüvœZIs)ÚyôJÒô]7¦jç··óÔïŽVdrœMÓñ⤔ £‚Z„T3Æ"ý(”m±þžÊÏ8Ç”üA@ÇֺșÆT˜9ˆ¿Œ °~*—Ü¥hçÑ+9Öwݘ^#~Ÿï÷8iFÖ‡„¦±ÖKY»@a1&üö˜ØU­FÒ\³Lò蕤é»nLÕÎo}3ôá™RðGƒå c²‘éèÄp)Ѫ—x=&qÖbqŒx˜¦Çž8vúg›È’µ ¦crß»r”מ’»f™äÑ+9Öwݘ^#~Ÿï÷DÒ¤`“ÌÀžÏ˜]°,LCÆäîÇeɳLŠè•¤é»nLÕÎoeŠ* úMBLXaLúâàm/‚_¡[x¨[älL¿íI‰áÁ±'çÇ3α„Ö»HlßR>ó+7Ò­c×8ùMîše’G¯äXßu`zø}¾ß㤱^j¶ãxÉöÊ•¦ÁÓÌ!_=&úÍø¬r*“Æ»¿zô2i®{“¯v~ÛÔAÒ×kÓ©hÑ+IÓwݘªßJYØ+.E¾xËc’£Ø l²­ kŒIÿdd­L”2¹ø(cš¿Ùd6Ž&}öš|s¬44&¤ï©œƒcú(ÚeôJŽõ]7¦÷ˆß~Vü1™r#útÎ^¦cÒÇûŘôYÏ `:í"z%iú®›SµóÛÛ.ë¼ dßV;[¿IÿÂ%`²-Zl}cÄc]æ“À4+~kY `“\²Ñ:¥icéfLŠÀõ+)ÉŸŠv½’c}×M€é=â·Ÿ¿#i‘Z…¡÷ùtÁÜ4`L’àfL¤_®0Šv½’4}×M€©Úùí)‰ƒI Õœ/ÑîÚ‰³«=kŒÉô©àÛ">ÿ(cš{’@K$’` Ó337v&ºoÐgÇ\ ˜®Y&yôJŽõ]7¦÷ˆß~VüŽX DÐo}~] 7õŸf‚|mÛžp¡Lp*ÚEô2i®{T;¿=+åqô·ÑJ‹Œ‰!$};c lGâkŒÉû6^÷˜ûý¤ÆÓߊ•Q-Ê1ïüÎMÃS9oI!ÁÆÉ/\íÜyôJŽõ]÷&xø ³â·–IZZ'óe…©ÿ4K,îzºÅÀõ蕤é»nLõÎoÖ:´øPˆZdL6ÍÚ[ó–w),kLvïKé„mn¿ü/À4=ó[+Á)N~ ÓHcòîžùE­Ý… ®AÞyôJŽõ]7¦÷ˆß0»ðÒûA ¬’È–¦þÓ,é{3&­"¤LçË"z%iú®›S½ó›mª½]>Fˆ~[à|1…`z¬¢òªá§…L©–áarÊ/ž¦ÙÎïƒ>šLè>×¼ÿL…i¤1á¿¶=K«WÎvî"z%Çú®›Ó{Äo˜{¢¬ßvÝŠ>в邅iÀ˜ìÅŘlîF˜®Y&yôJÒô]7¦zç·‚C²£gÓ˜`UcÒ“mé‹Z»¥+)îœø˜ùIÉ6Ì=Ù` “âwÒ‡”Óþ0ä –…i´»ïï7µºLñ¯½’c}×M€é=â7ÌŽ=Ñô‚¨9¬_„|P\a0&f cÒϹ¥1³LŠè•¤é»nLõÎï肚”ëi9…°È˜ôÅvÿÆÙ‚qZ8Ò;ƞظo"¶y+)=8(îüxÆ9Ù#i­¤Ÿ_ÌN~KÓhÊuòkk`íp*ÚEôJŽõ]7¦÷ˆß0?öDœî6¾>o~+LÆù˜}0&pÐ8•Ã{–I½LšëÀ„õÎïâÛæi²ÝŸkŒ)B lZ¿hµ²ðâOƒepúBÛ“b—6&œ¿mŒvâ@ÌœSa1&ï&9þ¸ 0á©hÑ+9Öwݘð=â7ΊßàmÃm$ý.üSa0&ºº”mOu“1á©hÑ+IÓwݘêß1 úL·Ñ#~µó;J)ê³;ØÄýµR.ôJ™Ïû,ÓüÂKbûð؆gÀ”›FŒé³òô³»0ÅFç7Þ[,³è•ë»nLï¿q¶ó;jÓ™]v%¥0 x¹j–ÈÍÎo<Û¹‹è•¤é»nLõÎïh³¾´.ð–J¹Ï‹}b›«äPí¸Ä«/Ôÿ³L»ò$0ÍŠßN’´RðYçwimâIxÏü}Q˜NE»ˆ^ɱ¾ë&Àôñ§;¿ÙDkMa‚”•r…ix*çÂ͘(´J¹«;^Iš¾ë&ÀTïüÖ'o@[j.>®è×p¾ØT¦(¶Ëw±]Ø{€"bpOžÊálç·c}'ì À¥˜µ ¦á&ÿÝÄ}c!žíÜEôJŽõ]7¦÷ˆß8+~û(6ˆ†CJ)?1ÉMÆ”\ _©É˜NE»ˆ^Iš¾ë&ÀTïüfŠZ)T›½Ê˜ø˜×-1ùðY¦»Ô`©ˆ‘´ sÖôó(0Mw~;›2–Jùí‚Â4šùÅßéJŸ§rxµsçÑ+9ÖwݘÞ#~ã¬ø-`ŸE²VŸ•r…iƾ§rŠ$Ò{B§¢]D/“fàº0Q£ó;+0ˆ$¯ð´Ê˜l…Þ1ZW‘x±]@ ¦s65œÑä܉fÅï`w’íÀK\ÈŦá̯ï&^—¤!~Ó©hÑ+9Öwݘè=â7-ˆß"âVJ1¦Â4:•KrÍR’㌉¾ŠöoôJÒô]7¦zçw×¢_Þ¤Ìeµó[_Œ¶êÌ'ù¿Ø. PB•ª¥'ïÊÑìØr¶R´X ¹ŽY˜FŒ /ÆdWÕÀtÎ2)¢Wr¬ïº 0½Gü¦YñÛ‰‡(ZuhÍ‘-#(LÆ‚÷©\tÇØÓ0Šv½’4}×M€©Þù¢°o 1°Ô.ðÏ1è…Mö¶×´ºŒ xÁ€•o)¸= L“âwr!ûcCR–c¹iĘ"ÜSRmÆg˜Â_=z%Çú®›Ó{Äoš¿õÛH¹ˆMbÍ’¦0õŸf1¥t•Ñ–Á6€éT´‹è•¤é»nLõÎo±i'9Aˆ+¤ÎÛ@+Ûü„ni‚¥2& ÛBÀd¥Ü“—xizì‰c›lÿ#ÛÄSš†» ¿}LZ#7,éše’G¯äXßu`zøM³â·>(’‹èD_”¯oÊMý§™–ég—²‚”Cnô1Qú«G¯$Mßu`ªw~KÒ/N<6ÇĸÚÇ$ö'c\)„ÅѺZÃé—Lì.¯–tÃÀÿ˜fÅo"öе6»î˜ Óˆ1%7cBhœÊÑ©hÑ+9ÖwݘÞ#~Ó¬øØÆ]¢ ’¬þ/LÆ$]5‹Ý]mSpõèeÒ \÷¦PïüÖüQ„PdÒÿ[eLèD¿,qefŠ1&ô¬¯ Ä…Ïåŧ€)LŠßÉ¥ÈbSX(æ÷1 ÓpO¸Oå\jÊÿW^ɱ¾ëÀÞ#~‡Yñ1D ›)’o°ÈMÆd«ßOƤLjÓ©hÑ+IÓwݘêßÂÎŽÔôÇV"¹LŸÛ œ€¼v%EFH1xï¢{’1…ÙÎï ¬Q‘Òù8›ùU˜FŒ‰ø»»PZS8Û¹‹è•ë»nLï¿ÃôÌoŒZuý?—²K¼…iÀ˜Àw}¾D14NåÂ5È;^Iš¾ë&ÀTïüNZéØu2-瓾؉M‘ e±IQÜÛ,V\sðähÝ0ÛùDŸ*H¶¾²+)…iĘ}Sàc:Û¹‹è•ë»nLï¿ÃüÌo`¯ú¥ÏÄïÂ4`L^àšÇÄ6 ¿L÷ ï,z%iú®›S½óÛîîëßú‹ÄÕ>¦dƒy#)yZ<•C+â$ÅÄúÈ“À4+~Ûº6DkFOùÂËÂ4š+/ç÷ÀµV„‡øW^ɱ¾ë&Àôñ;̊ߘD[öóR.7Ýó©mVY£Á2œŠv½’4}×M€©ÞùGkvÉ­”;^l»ªlÈ/Þ•3yÊÙŠ»nÇO6X†YñÛG$—§¿’Ë€©0v²»g~;ßêc §¢]D¯äXßu`zø¦Åoë$ €kL…i¤1…sð2¦øé8ª_Šv½LšëÀÄÎoý©ƒÂCÐÿòê<&»Kª¯#},®>˜RrÖýý¤ÆÄÓ /C0ögÇ“Ù}ÌÒ4Ü](÷îB†ÏüïJŽ][,óè•ë»îLüñ›'Å拓·uKñ·”+MÆDì.¡V¿–©Ñ`ÉðW^Iš¾ë&ÀÔ˜ùÉrœll\ºÄ{¼m’0xZ›ùýÏÿ”fÙ!ŠÒ¦t,¥{ ˜¦Çž$hÆcp]Ƙ Óˆ1yðç÷@IÅùše’G¯äXßu`zøÍ³â··}5IŸ~)d3¿KÓ€199×Y+cRi1¦SÑ.¢W’¦ïº 0µf~G°…•^yÏòK%œHdã Ââ 8ë5¶dÅa€ˆÇ\ƒÇ€iZü¶Û{âƒ}ŽùÃ/7 w2ߌ‰]ëáw)ÚyôJŽõ]7¦÷ˆß<=óAÌ`›HÒoó[iê?Í´þ¸k†äZO³kw½’4}×M€©1ó›%Z«þ÷³Di‰1qŠ¢€,AhyA`FlÍö®= L³â7&vlzv*W˜FŒéÓb{0¦C«”;í"z%Çú®›Ó{Äož^xl~+ 4;7õŸföeºû˜ÐQ+i®-–yôJÒô]7¦zç·â‘WºÄZŠE\ZFp¼Ø™.`Kâ–.ñ©ÐªD—5+øg5¦Yñɦ·è¯$Êz3`ÊMCÆtß•;V\5rìT´‹è•ë»nLï¿yVüFB¶~$âwa0&fkLNbc}S<í"z™4×=€)Ö;¿9S¨ŽÁk¾¯ö1q@'Z‹yèû˜‚~aÙ[WªtüÉOM°ŒÓcOÔÕDÙ~…ßñÍ¥i°í9yºrLUØ â5Ë$^ɱ¾ëÀß#~Çé±'ö ðhC²yÌ¥iÀ˜Âõ Trþ37§’4×,“\R^ʦÁ¶g»xæ˜hÅÛʱKÑΣWr¬ïº 0½Gü޳â·Ý\$´™ž2ñ»0 Á½‰7ØNÓFÒœŠv½’4}×M€©Þù­üÑ‘nG[<µ¬1‘ˆ]˜ ÒbƒeÔ Ò9}Ó$Tô0ÍŠßÄ>(ÐR@Îå‚Â4`LZ¢^@­:4J¹x*ÚEôJŽõ]7¦÷ˆßqZüQ«ýOÐ|ÎÄïÜ4`Lîé¶¾qW.^Šv½’4}×M€©1óÛÚ®HÁåXˆ»Ê˜ƒ;Z¸†X+åì¯ÝiÁ ŒéIÆ4»ðƬ•ÿÅ쀥0 “Uõ×îÂdZ=ÇÎ-–EôJŽõ]7¦÷ˆßqºó; 0Gðy»@a0&Ç÷½®зêÿ«;^Iš¾ë&ÀÔ˜ù9ŠÝ qZâ®oâ l»%Èâh]»Ÿ§/âd#&Ü£Ó¬øì>rÌGëæ¦c t³rÛ2ØzøŠv½’c}×M€é=âwœ¿µâ›tdÝ/Ù<¦Â4`Lιë®\8šwªI“NE»ˆ^&ÍÀu`JÎo­Ëí§^ß’â”~9‚ k3¿å!FÔìˆT¿jO.#H³â·€>§XkK”l®|i0&›ér1¦ö}Ìt*ÚEôJŽõ]÷¦ôñ;ÍŠßΖ˜)ïO6f㘠Sÿif0®¡fc‹f§SÑ.¢W’¦ïº 05:¿QД± `º<]€1ùp´ëo¾x%ÅzmHœs!rxò®\š{" ‚Z°ÍåcÊMÆdC].Æ4ZRÒ5Ë$^ɱ¾ë&Àôñ;M/¼Œ˜ôiaã±²›ß¥©ÿ4 Ñ×'¤´þj=Í®-–yôJÒô]7¦zçw°)l]ÙÒäø¼ÅÆã’‹ƒâôáRÐ'@}ý“cOÒüÌo²ùT(Ûö\˜s媯û˜‰¼kÓ=È;‹^ɱ¾ë&Àôñ;ÍŠßhk!˜¼õmÿjL¹iÀ˜ØÃUv'­ –‰ÿêÑ+IÓwݘêßÊÝ1 £O ÓqƤÄ0y°v$J+/>Ú¼­ßs¶‚OON°L³ßÑ(`tvñ³>¦Â4`Lî_» )PK.8Û¹‹è•ë»nLï¿ÓôÌoRBžÌ6ñ¦c¢È—ÆDÂ-a2]ƒ¼ó蕤é»nLõÎï `½ê)he°r÷ØÄ{ )¶¹°º¾‰@!§rÓ´ømKК³>¦Â4`LéÚj+éõ-n䨥hçÑ+9ÖwݘÞ#~§Yñ;ØB•˜uå–¦c"¼…Z’æQ®œŠv½LšëÀ$õÎo[Ÿ”EéÞÒú¦ãÅ‘‡EˆO倭Ͻþƒ)=¹¾IfÅo`C‚#òg®é¿€©0 vþk•5®6ä9í"z%Çú®{“¼Gü–Yñ;€×ÂÚJ¯|}si1¦€îfLغÄ+§¢]D¯$Mßu`ªw~‡‰@´šÓ¯Ïê]¹¬AS¡‰ÈÑÒt[ßÄÖò…l{þøÉK¼2+~£MÔBò¶„;¿ Óhw!»{ÛslþÕ£Wr¬ïº 0½Gü–Yñ[lò˜”ìè?Ó˜rÓˆ1Iú2&æÍ–SÑ.¢W’¦ïº 0Õ;¿ƒ>‘•‘W÷ÊYo¤MdŠ^kÁ¥ –ʘDß,[Xë0=©1Élç7jYéÑFD"@L™iÀ˜œ§ë0 Rj­¡—ðW^ɱ¾ë&Àôñ[¦^JÒ$NŠ)!{ZšŒ)8N_)5NLäÚb™G¯$Mßu`jt~Û mÑ‚JÁi¥;û˜¢>¹Õ¯À‹ŒÉzÍÑ7Eb¡GK¹Yñ;°­}±^öù–”Ü4˜ùe{g.Ƥoo㮜œŠv½’c}×M€é=â·Lw~{JcdË Óˆ1Ñ͘7îÊÉÕÎG¯$Mßu`jt~{"»Ê›âšø}¼ÁkM|Z]xieœ‘8=9(N&ÅooͦZabÌtÌÂ4˜’Êr·ŠžSK.¿zôJŽõ]7¦÷ˆß2+~ƒ­rÑܯ0YšŒ à¾+GÑaýi&îT´‹èEÒŒ\·&)?ºc"C•dwxy}º€iÞɰ%.¯GS¥“·’„#<LçÇ3α¢=U8jVæí…iȘü—1E¬³rq×,“(~ŸÏ8Ç¢7ýÆ+ ´{·Ù©\n0&ü®LçDѺâNE»ˆ^ɱ¾ë&Àôñû|¿g’FÉHpZxØ–Ä,irÓˆ1¥x÷1ÅL]Kú«G¯$Mßu`jt~‡¬4ÏÖWf½}Nå‚V`c¿Ïën+§r¬y*)srÁ= L³ßÆyÁö+‰ËXya0&}[/VmÜd#ÇÎvî"z%Çú®›ÓkÄïóýžH™ã¡Òþ&Maê?ͬ©ï>•;V[דæT´‹è•¤é»nLÎïã^‰~yC¿ÜǤ•XBDýÍÙ-¯oòìmá5ƒ­U˜fÅï¤o„M =hïïï0 Sp÷]9Í0ö;í"z%Çú®›ÓkÄïóý'MBN’x%æÙ¯ÒÔšQ¯Ƅ­›ßâ.E;^Iš¾ë&ÀTïü¶s~»%Ç6ÂrõTŽé«ÅG­ÆÖJ9eLÁfW:¬ËâàjÓtç·Sú„Q ßÄ[˜Œ‰øî•c}Z¿«;^ɱ¾ë&Àôñû|¿ÇI“”ŒxŒQ®>[FXšŒ)Ú|œ“1@}“>”þêÑˤ¸îL¾ÞùM”‚Cp·È˜ˆ¬ÑÝ G¡Õ –ú.9Ñ?XSâ',Ïg"Çœ]eN6H$FX˜F“­£8S”ØÐ˜¼ÿ«G¯äXßu`òï¿ýôÌïäõùªä_>ó¿)7 SHtÍc>†Ê6’æäG¯$Mßu`ªw~Û5u%Ž /+×Ý>Œ)3=lFCZ9ÒûÜ•óC V’(g{˜æg~ÛÏ”’ÄlSam{–pï.´ê«‘c÷ ï,z%Çú®›Ó{Äo?Ûù8‚²±Ù‰Ii0&e—˜‚v;¾‘4g;w½’4}×M€©ÞùM`•سSlYÕ˜H¿%) ƒã«²È˜ôeV’ õÓlç·–áÁfD‰rÈ|Sn0&ðßÝ…ÌñÍâÏvî"z%Çú®›Ó{Äo?+~I.y}¬'áŒf¦c"¼OLì>EC˜ô§¢]D¯$Mßu`ªw~£Ø0&±Ûr «wå0¥H6÷„m²Ö"crQ´‚ ú½ Lî•;?žqŽE&ÛìmsN>(®0 ¦¤Z&\ŒI®õð;í"z%Çú®›Ó{Äo?+~G" ¬Ø]¹…iĘ|ô7c–0éÓ_=z%iú®›S½óÛÚ˜G[íB+kðy±C@²¢°z*gr‰í~òÑZ<{r~<ã‹ZY&ÐÌ KL…i0W>^@m[`Z:æ©hÑ+9ÖwݘÞ#~ûIñÛv¶ËËU\¹Wþ×4bLþ_Œ }ƒfƒû«G/“fàº0A½ó›¬/ÔsR€‚µõMÇ‹cÐ/ êo¾´_ü³"Ü;Û¶™ *®=ɘ`zì‰mEÐÒö¸½Ÿ3¦Ì4ÚöÜ}*‡®q%EKØ¿zôJŽõ]÷&xø ³â7 Ùô&»Ä=)LÆþnر¤v8í"z%iú®›S½ó[b›ö­‚]YÕ˜\t àb´k ˜ôÅN15ÀÈŸl€Yñ[eÎ'@Ê€©0¶=§-°o6ñ©hÑ+9ÖwݘÞ#~ìø­õŒûSv*W˜Œ •$\Œ)alhL@õ蕤é»nLõÎo ¢ð à„ ü²Æ´þÓB.žÊ‘©·jO`”+<·¾éüxÆ9 ÅÛ6´!Q¿ÀT˜ŒÉÖå]såEŸS»¶XæÑ+9ÖwݘÞ#~äømB©@´ Iè~¯ ”¦c"Ž7cjÝüø(ÚeôJÒô]7¦zç7†m}‚–s´v‰÷x1Ù@a»³œV×7€ Ñ9»øå5mâ=?ž‰C§ )ºè³…—¥i¸íù^9’4f~i²üÕ£Wr¬ïº 0½Gü†YñŽ­Œ1²i¥¿Œ©0 “'¹NLlk`cº¤¿zôJÒô]7¦zç7ˆíI òí;JšãÅä8¡íH¸t*ggôuÀr æ=Fë>ƘfÅïdË$•þ¹Rc*LÆ@7c2i䨩hÑ+9ÖwݘÞ#~Ãlç7jÍeBä¢ä,sÓ€19¼ÏÅQ³¦1’Ïvî"z™4×=€ ëßÀ6á'±Ó«¥áöâ ÁÎü£E`úç]Nþàkü 0á¬ø¼·e1²5ô¥iÀ˜¼|Ó1Õ¥žcþ¯½’c}×=€ ß#~ãôÌobo "¼Ýý¦ÂÔš¡ÞŒ‰Rlåâ5È;^Iš¾ë&ÀTïü‡ÞñÑ Òjç78Olp ûµ –îh‚rlƒo­ãÉKœžùÍÁFƒG’¼”ËM£mÏáž`ô•+)x òΣWr¬ïº 0½GüÆYñ› ²- EÛ‘Êå¦þÓ %ÝB-}´5’æT´‹è•¤é»nLõÎoÛOfëݘ®W;¿½–! 5ð;^PÎ? /µ,QªEdó¦éÎoÇ‘):ýcy‰÷×4˜ù•è¾ÔPÁ»‘cW;w½’c}×M€é=â7Îv~SLκʀ!d£u Óˆ1Å»þÇàZ –x¶sÑ+IÓwݘêßþ؈ËÄ6aõTÎ{±Œââò2- ½O€Ÿl°ÄIñ;™¯]¿u„9+/Lƒ™_¶ûåbL>5V„iÈ¿zôJŽõ]7¦÷ˆß8-~c 66?F~/X–¦cJñžO­Ÿpëº^Šv½’4}×M€©ÞùíÙF€€âK\íü¶™%ÎGïôÅi±Á¬³Â¦Ì%‚ùdNw~“X]k³!9cL…iÀ˜ŒÙ\Œ ¨©1]íÜyôJŽõ]7¦÷ˆß8)~‹ý}ì4q ~…ÉÒ4`L‘ïM¼ˆ­…—BLšëÀDõÎoÀÎæ–•jìØÀ†#crAkºÕáŒõUA’mq|˜hVüöÉîèX+ûooií.¤Ss³M<ú+6rìT´‹è•ë»îLôñ›fÅïhWÑõya“krKÓèTÎÝ Ô0X¿I=i௽’4}×M€©Þùí$xÛƒRˆ~éJÊñb$}„Û2ÎKwå”1éSÙiÝ‹"üd)G³â·$°U·I°ü®\aÍ•ÿÎ@WˆjiLt*ÚEôJŽõ]7¦÷ˆß4+~;â¤ÿ¶¶<΀©04¦à«1A+iNE»ˆ^Iš¾ë&ÀTïü6•ˆÈšlCñ*cb;ºŽÎ&ë.¯×’DËÛnk힦Yñ;!Ú'¨,NùÈ/0¦Ñ\ùîÝ…1b‹1…¿zôJŽõ]7¦÷ˆß4+~{Nöa'°ùÒ¿ÀT˜FÝ÷º¬ó¨•4§¢]D¯$Mßu`ªw~[ÿ5+2ïRZ¨Æ>}L6Qmø‰-;Y\ßä ’l¼­~òOÓlç7Ùd* hÍUc*LÆrO° «t9v¶sÑ+9ÖwݘÞ#~ÓôÌoÓü¼õ¥ôÛcRšF“ð}W5ƒIs òΣW’¦ïº 05:¿ñ ŒIà;?o*iìÅ`U˜M ‹§r虼ˆ~6ÿòQ`š¿õã²ýÛ(/årÓ€1y÷”TN­&^:í"z%Çú®›Ó{ÄošíüˆÎîVÙ¼ã¼Á27 St÷pkÔgO#iÂÙÎ]D/“fàº0…Vç7ŠÍ î@ÓEÆÄ Èæ;@X¼+‡† Ùv¹)ÌŠß¶¾“]t¢˜üonjLw=1µ¦¤†SÑ.¢Wr¬ïº0…÷ˆßaºó8 èÃ=¤¬þ/M#ÆD§bߎæ]¹pµsçÑ+IÓwݘßQk8å;A"­•röbë~.8’¥ËÏ3ÁŽ–˜Yyד§raZü¶Û{Gó¢“ìT®0 îc ß,‰µ€éR´óè•ë»nLï¿Ã¬ø ¤OVÔÙ#fwå Ó€1qâ/cj”ráT´‹è•¤é»nLõÎoÛ¬ QQ­2&ý5A™–ؤYìcBd…50 \‚'OåÂìÂKçl:•³UTùÉoa0&÷œGZkèCø«G¯äXßu`zøæÅoç"؆Æ|Sn0¦ðÚ+Þ…Fó[¸í,z%iú®›S½ó›ìd‚g»ºÔ`y¼˜Š÷õ‹¸8Z×v£Cg³¿åÑ…—azæ·m¸q6gØq¾"<7 4&; ¼S&cºyçÑ+9ÖwݘÞ#~‡Yñ[‹$¤ß!ÊNå Ó€1Qü2&‡­“p*ÚEôJÒô]7¦zç7i%miºC¯N°è‰PxMü>>}Ç”ÎÄ”ü³À4+~3ê‡Â$ù\ùÒ4è•À›1Ë/ê9v*ÚEôJŽõ]7¦÷ˆßaVü&[ó´vЊ#¿+—›FŒÉ¹ûTÎ…Ö•>í"z™4×=€‰ëßúµÑgoü |[Õ˜Ž½mŸç…:ð`LöfY! Ίë‰çÇž cÔœô‹±'™i¸í¾Ûž©5Á‚ïY&YôJŽõ]÷&~øÍ³â7‹M:t”ô¯œ1å¦cbü2&ßš`ɧ¢]D¯$Mßu`jÌü¶)Òvÿ]¢2§UÆÄú 9‰ú$_eL¶#ÍÑEïäÉS9ž¿m޶¥^²K¼¥i´íÙù›1„ÖÃÿêÑ+9ÖwݘÞ#~óôÌoÍ~¶ú?2a²0 ±¿·¤8ߺ’Â× ïË\«þ?í"z%iú®›S½ó[ÉJ$[,GúÏê&^‰â™‚‰²rø`LÎÛ½aëäϪÍÇ€izá%FûQ0j=î2`ÊMÆð.mIeëáwm±Ì£Wr¬ïº 0½Gü޳âwðQk%g—x Sÿi¦_"¸5&jž˜¤SÑ.¢—I3pݘR½ó[¿¶Š£ús“þ³4Z÷x1;¯| ˜“xg²°²K­ç\x™fÅï oAbBïdÀT˜Œ ¯÷ÃÖ…ynŒÖI§¢]D¯äXßu`Jï¿Ó¬øM.I"å•”Ü4bLøíc²m¤9í"z%iú®›S½ó[¢–b‘E[>µÊ˜8)"‘"K@\ [Ƙû2µ$vGø0͊߀mª’HÉFë¦c-Q¯Û©ýð;í"z%Çú®›Ó{Äï4/~ €3Rò9Gû¿3Ó1Eùcj=ÍnE;‹^Iš¾ë&ÀTïüÖOÀ6€ziuº€ÒÃbÅdY<•‹¨eœõ)Äà>sh¦Yñ[ë$Ûrg£\\ÞÇ”›Œ è;W>6W„§SÑ.¢Wr¬ïº 0½GüN³â7ÛF-g—##æ –¹iÀ˜¢¿7zR«Ç$ñ_=z%iú®›S½ó[”*!Ø¢2t+‹N>Œ‰(º€02.jL´’Ü~Ñ´>y˜fÅï胇c3pÈK¹Â4`Lï™ßȧréT´‹è•ë»nLï¿Ó¬øí}P¦“D?˜/#ÈM#ÆäýÕcb_F»@:í"z%iú®›S½óÛfvœDñi©ÁòxqÐRÌê9}÷ʱ6'€9޳õÇ€iRü¶ GŘ‰ß¥iÀ˜”ˆ_· ˜ZÓüÕ£Wr¬ïº 0½GüNÓcO‚>XÑ„ZÌî1•¦c |oô»o[O¹f™äÑˤ¸îLRïü–h}1 ¬¥¥K¼Êæ9O.ð¢Æd­8Îy­ä x~Rü–iñ“VµÉÚMóõM…iĘˆå˘¨qS.E;^ɱ¾ëÀ$ï¿eZüŽö‰ØôÚìiV˜Œ)Pº5&ß¼+'—¢G¯$Mßu`ªw~ËÑL„,Î ¬2&°)”"¡¸ÅS¹€íòŽ>›(ûŦYñ;8PØ.çd[R Ó€19ˆ÷̯À­K9í"z%Çú®›Ó{Äo™^xé(0Ø,¶”üÎcþ5¹»I‰BCc’k‹e½’4}×M€©Ñùm³X¢mQp«›xÅ¥AEfef [‚¢¸# .~ú˜¦é™ßLHämÈT~» 0·=ß§rZÃåäG¯äXßu`zø-³â·G,è‚óZ(ý&Ma0&Lñê1ÑZ=µÓ©hÑ+IÓwݘßöXs% á²Æä–‚5I&ÂÅ™ßäU×&0‘IrÓ¬øÑö[Ú’²Aq…iƼÜSø\é®åØ©hÑ+9ÖwݘÞ#~ËôÂK­ª£æ?ä3¿ Ó€1ÙÒضöÊɵÅ2^Iš¾ë&ÀTïü6áÚ6) ’ÍjYœ.Ùƒ²-Ãw*èTÒØ–”„ÑhaäI`šíü&oÝ ƒÙRÕÒ4Úö|]âµÁ„[:æÙÎ]D¯äXßu`zø-“âw´{±âI¼CÉ’¦0S¸{LÀé3¿–4^ÿù«GÏ“fèº0ÙYeLÉF=VvV~¦ ȱ¶2DÔªniPœ~ Œ­ßœ”©¥çJ¹ëã™È±`ô™Ñ£@v‰·0 îc&»Év2&òReåú“ÝŠv½’c}×€É~È—Óõ~“&eýB2ý6¿•¦cý"_"%Üuñ[²k‹e½’4}×M€©ÞùHRPTrâaeå‡1öújOieüå1ÁÒÖ‘pÌ‹‹ø\)w}<ã‹6Wlþè¹;çß}L¹i´í™¾såAêKUõ';í"z%Çú®›Ó[Äïëý'Mò¶1÷Ž¥Ø+—™ŒIÿºNLô™ß|š]ƒ¼ó蕤é»nLõÎïDÇ–2»ôFa™1™ ›¼Mՙߊg1ˆó¨o[|°”»>žqŽiNÊD±OÅ2‚Ü4ÚöŒ_Æòï?î'ÇÎvî"z%Çú®›Ó[Äïëý'M¢è\“2ãLü.LƤàq=ݽ›l$ ÿÕ£W’¦ïº 0Õ;¿µþLšêÑ¡þ&«}L1Ù¡?iè.µ crAˆíÅçTµÇ€i~áeT:B©³+)…i¼íÙÝŒIk¹FŽÝ[,³è•ë»nLo¿¯÷{œ4‰™¢À!ü…lº@a0&'xÊÙW«Å˜®AÞyôJÒô]7¦zç·þÌI,ßGZ=•c¶¸¬á`e.ïÁ˜ì:‹–#ñXÓò¨Æ4+~kI«DG_ÐçËrÓpÛ³ûn{VrØÈ±SÑ.¢Wr¬ïº 0½Eü¾ÞïqÒ¤h]ÂD"ZÊê©\°›(þèCN«§rZþ¡ÖóÂúÙºE“Ÿ¿ˆ¸¨ÔÑ–YýSaí.´Ëáçɯ֬ÕÝ…ú“Šv½’c}×=€É¿GüöÓ /Yô{•‹@­¤¹Ú¹ó蕤é»nLõÎod‚>㉌ÉnºéKÁÖíÌå=4&ç0€Â R¦ç.ñ^Ï8ÇbЂÖV2åwårÓpwaJc²™n»¶XæÑ+9ÖwݘÞ#~ûYñ;xã!B}ÊÄïÂÔšyº¾DÊn°¥1Šv½’4}×M€©Þù6ß>RФåÁ2cò +¤±ã°¼%Åš ´îU\KOÓôÌï(Ê­ ²™_¥iÀ˜<Üã@m9suì‰M=ÿ«G¯äXßu`zøígÅo;×¶¯>§ ù<¦ÜÔšyQ¹‡Ð&8í"z™4×=€ êßœ¥»ÍEZÝ’‚ÖÂä4×:¿­CÞn)g ô$0ÁôÂKÒ¢V¼¤¤…í/0¦còÄ·Æd«Ž9vm±Ì£Wr¬ïº0Á{Äo˜¿ÅëCH9¿ƒYçwa0¦$÷ YÏ®Õǧ¢]D¯$Mßu`ªw~+WÂhûIV;¿X˜lGp‹›xµvtÈ N)Á“ –0+~Ûe¥~Z) dó˜ Ó€1éŸpo{ææ•8í"z%Çú®›Ó{Äo˜¿ƒ$›'ªÅuÈ×7¦cb羌Iâ7œŠv½’4}×M€©Þù ¶‰Ài=x•1'-Æí.†•Ñ–46㵘ÒÿÄ'5&˜¿Dß‘d·’3Æ”›:f ÷<&£†-`:í"z%Çú®›Ó{Äo˜¿õËm$Ûè˜ ÓHcbÿÕ˜B}KŠþd§¢]D¯$Mßu`ªw~Ä ey¢´²åûØÀ&íêß~µ‰(Új-JŒ<·%åúxÆ9f'´N‚²ÀÈ!Ÿ`™›F›x ~7ñp}“þd—¢G¯äXßu`zø Ó3¿!%ýÂÛÈ#ŸÊ¦c¢ï]9ýF¶Ó5È;^Iš¾ë&ÀTïü†`#¿m•’ÂË꩜ ÅUþik@K¥œ­^S,ó¦ã’- ˜fÅoOñè«V¬Ìf~•¦á&¹5&Òw§‘c§¢]D¯äXßu`zø ³â7Û=v[ލOÙLü.L#ÆD÷tA&lhLèþêÑˤ¸îLXïü¯ü1X!G.¬žÊ‰x,F_ìcÒúM"§hŸÛ’r}<ã‹ì´6M Ø–¼ì®\f0&Ö÷ž+/õѺú“]Šv½’c}×=€ ß#~ã¬øúu· Ñd€¿ÀT˜†S¨O°ÔŸ þêÑ+IÓwݘêßÖEä¬åÔ#-ÏüÖŽíÆ€_&÷?tŸñbŒÇ­êÇ€izìILˆ>ØÃÊe –…i4W^ÂÝÇ[ÀtÍ2É£Wr¬ïº 0½GüÆIñ;&%°ÇÖX[Ëñ›4…iĘðÞ’b/iýÕ£W’¦ïº 0Õ;¿áX( Å˜‚“_ù­ "¦_kõWf¦ŒÉ6±ç‘>y˜¦Åo´yvsR–c…iȘÄ}Sl´ à¥hçÑ+9ÖwݘÞ#~ãtç·’+xÌY»@a0¦Är÷1…·©%ÍÕÎG¯$Mßu`jt~›8l3=“¿¤·…>&ÇŽ€È8-2&±;rΦžEÿhƒ%N/¼ÄQ?Ĥ5jΘrÓ€1±—{J*p뀯-–yôJŽõ]7¦÷ˆß8+~CÔ‡;¥ÅœÏü.L£>&Ä{‚e h\ÀSÑ.¢W’¦ïº 05:¿ÙŽÆl•µ:®v~­„C`Ûÿ´ª1Ù ñ(Á¾i¶ àôÂK²kû.§Ï˜ß+L#Æäî 61µõð»¶XæÑ+9ÖwݘÞ#~ãôÂËh{$MUvùhÝÂ4`Lê/ÆD©ÕcB×ËŒÃR»À§ L‹@¶+ie“ÁgK y›Z\b>&÷=L³â·fƒb¤>[¢âÊïï0¦ûTNkü+?í"z%Çú®›Ó{Äoš¿í¨ œ{Pä¥\n0¦@x}‰¬§LáT´‹èeÒ \÷¦Pïüލ%ÛÅ5Ÿü’øý)ŠmÝ¥]ÄùÜ*YÙ’¢´Â™üd)fÅodD;B‹$.»Ä[˜FŒéZxi“OS¹p*ÚEôJŽõ]÷¦ðñ;ÌŠßÄQâ1C8[FP˜ŒIkôp1&ˆÜ(å©hÑ+IÓwݘêßÑ÷ä0!@ZeLÑ%5lw¡Wç1Ù„¸èɱž? Lóß31>¿ Ó€1QŒ_Æ­-)ánç΢Wr¬ïº 0½Gü³â·–Õ )¬f¤lº@a0&’{ƒ…’Æ øp*ÚEôJÒô]7¦zçwRÒCˆ¸¶Œà8¼NÑùàCÀÅ –À¬ï~² PÁ?*~‡ÙÎoñžR0:ⲓßÒ4`Lÿšº§e}hÓÙÎ]D¯äXßu`zø¦Çž(A±}’’O°,LÆDþÛǤŸt£)\³Lò蕤é»nLõÎïÀÖ¤ëϬnI±)ŠÊ|@!ͦ4®1&A›1—´žGy˜fÅoFHòì2ÆT˜FŒIîM¼ LØbå§¢]D¯äXßu`zø¦g~s JÊ•ô{—ŠËMÆ„)^ÇOÞ‡Ô8Ê × ï¾aq/jI¢ß-" Z>ʘ¦Çž„ä]:VŸÿSa0&”»}BË.hiL×,“ü.E;^ɱ¾ë&Àôñ›'Åoq!%[r›˜²õM¥iĘþÕÇä|3i>Šv½’4}×M€©Þù$i÷d)gÅï(Êsl'Å|º@a0&k½rÌd¼FŽŠv½’c}×=€)¾GüŽÓâ7±=_ƒÍïÉÅïÜ4`Lvæz>Ílî!ÚV’æR´ó蕤é»nLõÎo±SDå,ú³óÊ=\ø¨'â‚bKJnqæ7è7L޽~R|²] N‹ß¬ï…³¡òËÜ4dL¿Œ©uW.^Šv½’c}×M€é=âwœ¿­Ï 2fWR Ó€1yjðŸ¹9•¤¹í»Ýâ5(^<•³×°âZ$À',Ó¬ø ¶NLi¯©_¿9VšFsåÞ· ȹ0Šv½’c}×M€é=âwš^xi qJcd –…iĘ"^O÷”à“@eÒȵÅ2^&ÍÀu`’jç78}6Ä¢“€²x*§/†dûál¥.´¦ ÕY ÌO2&™¿A«¾$L1¥l´NiÍ•OîfL6C¸Lr*ÚEôJŽõ]÷&yø-Ó /í¾'‘íópiL¹iĘÄ]]¹IBh”rrm±Ì£W’¦ïº 05:¿£íN°ÅpÎÐtµóƒÑ~ñ•Àc°æ'²%"!=9ó[¦;¿£mß„˜0âoŽ•¦ÑÌ/­æï¹òÊ'ÀtµsçÑ+9ÖwݘÞ#~Ëtç·m¢ŽÎNÞ`Y˜†Œ)¤/cjÓÕÎG¯$Mßu`jt~G°á¸Ö·q™11;r! »¥#½ƒ1‘8-ãÄÞ3 2¦iñ›HëÚ¨u¸ËF딦crwŽyˆ¾q*'—¢G¯äXßu`zø-ÓcOœ>(’ .¦Â4<•»÷ʧȩq%E®Y&yôJÒô]7¦Fç·Ø˜rF-Éde@ÀGcRlQto›ÑWç1±~&nYW*>9]@fÅo&šh¡DYSa1&÷¶g›ëÒ¦SÑ.¢Wr¬ïº 0½Gü–Yñ›#1¢¤ädSažÊÝ×èS$hiL§¢]D¯$Mßu`ªv~ƒS„¢­éc‹3¿ÁÚ Xà(ˆ—û˜Øóì°sìž¼’"Ó /õósQ+K­Q³‡_amâ¸g~yIv¹¶XæÑ+9ÖwݘÞ#~ˤø“¦~Ô‡DЯ~vó»0Ýó˜RP†S&ïÜ_=z‘4#×-€É—ÝÁ˜ ¢Í‘ŽVÒ­Ó1M §]¿¨åØ"cJIôµ@à´œ~°ÁòüxÆ9–”ü1Ùq~©0Sú×îÂàêÀ¤l󯽒c}×-€É»×ˆßçû=‘4hãŽô d›¬³!^…©ÿ4;.‡ßƒä0Ö,½»Ú¹ó蕤é»nLõÎo$Gvžœ2‹Å –Ö,`Ëì|-¦ÕéJ,9)_c‚Åïóãç˜í’¤ÈJàl™Õïï0 wÞ3Иb}á…w×Ë L³âwŒ`oEP Íå‚Â4bLAî –eÞŠv½’c}×M€é5â÷ù~“&ÙÔzï­É¦Sn0&­>ÜŘHâ·w§¢]D¯$Mßu`ªw~k%g(½þì"‹›xm(sˆ˜ÛìTN+o )e{TcšíüNŒÑiŽÂô›c¥iĘÜwåÀvÌÕélç.¢Wr¬ïº 0½Fü>ßïqÒØ2I"Š™óá…©ÿ4KúÙ^§ÓñxšUÉ·XþF/“fàº0ùzç7‰VSLVPÅ•ënc¢¤u+Û•7ˆ+3SÆdWxÁ¾dZCú^žÏDŽÙfý™´ÿ,õþ÷Ã/7ÓgUÞɘbCüö§¢]D¯äXßu`òï¿ý¤øížEœõ)gõaê?ÍìÖH<kÑÀõ蕤é»nLÕÎo­ÃB<{ʼn•-ßc²±¼ Àdgò‹3¿Q½Ý«àcÁ“À4)~'%º sÈuÌÂ4`LÒ·ó;JCcòøW^ɱ¾ë&ÀôñÛÏŠßÄZ[³–îúEʶ¤¦þÓÌ\¯ïƒÿh•¤9í"z%iú®›S½ó;Z“²–sŽmÙ"cŠú*´Ë@´¼‰W|°±B‘{RcòÓâ·± yÖÙ•iL…iÔùý9`ù0¦Ï^æ0]Šv½’c}×M€é=â·Ÿ¿mprÔDzÓo~F³ SÿiÉÚOÆd«Àt*ÚEôJÒô]7¦zç7v¶´ÒfÁ¬œø“Ö­ ØtTrK£uíT£‹ˆÊ»ž¦Yñ[¿ïÞNã­…1cå…i¨1¡ûjLGv ˜â_=z%Çú®›Ó{Äo?½ð£=$”ÉR¶ó«4 Sxi­ìÑ7Äom±Ì£W’¦ïº 0Õ;¿ƒÓ< Öû˜ìèÀø¡gZj?ïÊé3œôä%ÞóãçXÔØs²œ¿ÀT˜Œ ñ>¥Ô YÊ]ƒ¼óè•ë»nLï¿ý¤ø-¶ Ž´òCý6d›x Ó€1E8K9eLúЯߕӯÌ_=z™4×=€ êߨ´…l»œ‹×º½…S¹Èˆ•ƒ"Æ¥RΦ cP8ôÎ?YÊÁìØ¯Äуû‘²R®0¶=ÓWc2¡ºLpÎ2)¢Wr¬ïº0Á{Äo˜íü¶BŸï2©0 Nå<áõ=`}Þ74&8Û¹‹è•¤é»nLÎoPœ6xökËìÅÆ.F·<é`J)D[Fôä©LÏüF0®KZ¡ºlSamâI÷^9IÒ߬ØòW^ɱ¾ë&ÀôñfÅï¤äPKŽ|¯|aʹtu~³¦VÒœŠv½’4}×M€©ÑùíLþVs¸ÞŠÆ"ÎÆã1Ø9ÑêK›["sòvýþA`š¿í¶£°Ó3[ßT˜F›xèîü–à}ëáw*ÚEôJŽõ]7¦÷ˆß0Ýù[ÍqÌèø¦Â4`L.Ý7 XùM}KŠ~ìõ蕤é»nL­ÎoŒ)‰–b Ë[R0$»IìeyK ùd·ä!HŽÖ=?žqŽÙ=´mNH*ïÊýšFŒI™ÍŘ‚“FK \íÜyôJŽõ]7¦÷ˆß0Ûùí­\ Ëå_š]š“VoWç7Û^´FÒœíÜEôJÒô]7¦Fç·r¦ Îc¼[=•³.?o¿ode>«Œ‰Éõ­ Ž=9?ž©#`ŽÎsôyon3¦{w!5¯=Á5Ë$^ɱ¾ë&Àôñ¦;¿#"‚èç‘RL¹it*÷éÊýœÊ¹ÔèüÆ«;^&ÍÀu`ÂzçwPPð6Q¿=¸º%%h fØÙ8.­o2É£­¼ôµ¢{˜pVü¦h·¯£ÏV„¦câûâ¡D' `ÂSÑ.¢Wr¬ïº0á{Äoœ¿‰iÙ…úÊïʦQ“}¤ÆD£u=Â_=z%iú®›S½ó[‰=Z¶¬5XÚ‹‘!&½‹3¿íPN«Û÷ñäŠðóã™È1ýI(Á!VKvQ¼0Â5%U+{j”rx¶sÑ+9ÖwݘÞ#~ãôØ}¬"`±Síß{L¹iÀ˜lûÍù=1bëivÍ2É£W’¦ïº 0Õ;¿íN ’¶Xn‘1qB§oŽñx«“S 7Îlœù}~<ãSˆµ­/Zóg}Àϵ§Ì4bL¶ŽòÒ˜BcÇðW^ɱ¾ë&ÀôñçÇžDŽ1Ú\íLüÎMý§‹‹7c²a“¤¹g™dÑ+IÓwݘêßQq:I œ´*[½+â99Ûô¹zWÎéC_9—–qú†=ʘ¦g~³Kžì6³ÄìT®0 5&‚[cŠÔ˜’Š× ï9…&ò+÷p?ŒÉêŠphDœ–FëÚ]9‡6Ù@4<:Z—¦g~Û6o¶FöPÌüÎMÃM<7cJQ°qÀB× ï?•+LÆdS OÆDú¥j•r—¢G¯$Mßu`ªv~£Wh ¯y®ÿæÅ-)hí©M½YMðÙ+Z*6Ù»õè©ÍŠßA«| QÑVbÖ.P˜†» ÏvÛ]˜¤q»€NE»ˆ^ɱ¾ë&Àôñ›¦ÅoݶՔó-)…©ÿ4 âÓug”FO³p)Úyô2i®{S¨v~k§å,8-ã’¬œøÃñâdSSlt»ÒŸ¥KÛ+çÑþL[h Š ³â7kÕ… ÙA>¦Â4bL®SJ%Ò­aáT´‹è•ë»îLá=âw˜¿Å¶Å:ÑÇ:fí…©ÿ4³íJW±-Z®'Í¥hçÑ+IÓwݘªß6|Ä9b ì¤V“mºŒ˜¢–+kâ·Íüö‰ôoÅrùÌÎ| ˜æÅoÇ¢oˆµÂâwflâçé̱äÉ·~·¢E¯äXßu`zøfÅoe#õãv ŠvÜ4`LÑÁ͘B †Æè¯½’4}×M€©Úùm­×Š/úƒ‡Äk /íÅÎqÔ÷àÚϷ˜’â‘[.ãü“âw˜¿IËÒä’>\ô—ú¦Â4Ø]ä»»0¥Ö0ÂþêÑ+9ÖwݘÞ#~‡Iñ[ŸËÄm£uôùÓ,7 SüŒ¤8SHÐJþ«G¯$Mßu`ªv~#8ƒSàø׶ĘÄúüœØJ\j°4Ƥ.ñ£â¦'ÛÂôØ[¾Å³õM¥i´í™âµ‰'Z•Üȱk–I½’c}×M€é=âw˜¿Ù®s9@ý&åí…iÀ˜0Ñõ43ѶL鯽’4}×M€©Úù­ØÂú½A;F «ÓÐ'´ ”Kx•1E£ZB¶’áQÆ4ÝùLÇt[Âõ L…iÀ˜l@ÕŘø¼ëSɱ«;^ɱ¾ë&Àôñ;ÌŠßd«$}t>AÈŦcR÷k!¶NåøT´‹èeÒ \÷&®v~£Ò•@"6Úl©ÁÒ^ì.Šm ×Bpµ)Ä”½Ÿ’˜xVügW’mÇ;[RrÓ`Jª‚\Œ 95NåøT´‹è•ë»îLüñ›§ÇžXµ‘´D ú Ê)3 }žîc –|Í2É£W’¦ïº 0U;¿Ñ# ÛÔ©³¸%åè5` ZX «§rhcõìЛ% L³âw ¥Jxõ+™ŽY˜Œ‰=_» £ûÜ4¨åØ©hÑ+9ÖwݘÞ#~ótç7¢èW€mEb>)7 “}—.Ƥ”­qÁ’¯vî&Ð81‰§¢]D/“fàº0Åzç7׎·yÀ«{åP)¢É¼äƒÍXcL’|“OÇ^õ)Ίßb»·9é•/¼(Mƒ)©I¾» [rAôõè•ë»îLñ=âwœ¿ÙDLaI1ñoý_šŒÉ…(7cr­é‚ñT´‹è•¤é»nLõÎo°ùŒd›'aq¯he¡¿°QÅ•¶ñcæwò(d½ZFⓃââìÌo¸$‰!¹ìáW˜FÛž£»wj¹Ü8•‹ç ï"z%Çú®›Ó{Äï8ÛùmùQ(¤³M¼…©ÿ4³»F×Úú´Âd<Û¹‹è•¤é»nLõÎoˆŽµ:H¢,Ï-3&}!Û¸‹§r6†ØÖXe-þÉ-)qVüfëƒ×Ù̉lExa0¦Ò­1¡ç+?í"z%Çú®›Ó{Äï8+~§£å%jçËKSÿifkЮéZrAëiv*ÚEôJÒô]7¦zç·x AÙ@àUIWO6zˆ´:^Zßt®A0¦ú¿Ü£Œizæ·(k<–åia›Snmâûv;lí•‹× ï&ý0(®¥`—ˆŸlé±'ÖÒ…B £Snn{Æ{w¡¾;­»f™äÑ+9ÖwݘÞ#~ˬøm³[mXb"—Ïc*LÆ„án4Fú¬rª%Í©hÑ+IÓwݘêß £ÉÖé×WS~•1Ùö^L@}\{òuW€~¿¼2'IîQÆ4+~cŠ"v"¹_`*L£mÏþ˘üâ·œŠv½’c}×M€é=â·ÌŠß6K$بC§åû/0¦cÒïÃÕcbÓÊ£uåT´‹è•¤é»nL™ßA¿C>¸èõA¼ª1m`Ÿì Wë—ŒlþºMª{”1MŠßIXŸTL² …iÀ˜ô­¹““&cŠõè•ë»nLï¿eVü}²sРçI“›ŒI‹—ë{€ú°o%Í©hÑ+IÓwݘêß(àHfBrny“õ¸c”cõ⩜· qþ˜«¯åï“§r2Ýùm§ðö•w(ù<¦Ü4`L”uò+W;w½’c}×M€é=â·ÌŠßñ °Zú…ˆÙ©\a0¦»mæè]nÜcÒ ã¯½Hš‘ëÀåGwjLbŒ¢E‡u ¼·éÄÖµt%Eß.=ëÛÞ:w~<㋉í’c¯%j6%µ0 ø{¯‰|Ö…WrìT´‹è•ë»nLà^#~Ÿï÷8i’¹&ý ÀA±"<3 “»VëXïò§§©–4§¢]D¯$Mßu`ªw~“MiµþHkJZ­kŒIU-ã×î•ØÓŒ)ÅϪ«Ñ¹ƒÂ6Ré¿ÓìØÍ D™³½r¥iÀ˜€ïéÁ!ÕOå”õüÕ£Wr¬ïº 0½Fü>ß±v›h·'${ZšúO3´ ^çÓ $4Äo-pþêÑ+IÓwݘêßÁ{ÐZ#²;s‹Œ‰D_ìKD ʹ%MHG»—²Ì¨øÆOÓôØ›‘`ˬˆø·%¥44¦tOI g¥Z˱k–I½’c}×M€é5â÷ù~“&é7ˆ=Ûl¤b‚efê?Í0º{ö=è·£~bŽÿêÑ+IÓwݘêߤå§ôôâp­Áòè‹lK@(y·6Z×îÊY³‹äLÇ'i¶óM";“ ©0Sû®œó–ýíÿêÑ+9Öwݘ^#~Ÿï÷8i’-»HA+†¨Ïج”ËMÆÄ"Wý)5^‚»Ú¹ó蕤é»nLõÎo"›‡D”æáê<&²þHJÉ6Œ»ÅK¼v¯09Ò*Ð…Giºó;j:ØŒp[yž1¦Ü4`LÞ…{Ûsߦ«;^ɱ¾ë&Àôñû|¿ÇI“PB˜”ŽP€ìT®0 SàpÕÿ !T?1 òΣ—I3pݘ|½ó›!²V¡È—^Ú‹(ZMŠÄ‹ë›H¿ZvPÁíQÆä§;¿Ù†ýGgû³>¦Â4`LÎÑŘôåF)ç¯vîÓ˜]ßt~<ãÓŸÆ#:I¶)¿sÓ€1At×\yò"Îo¸íËÁ˜ÄîmHðÉQzTüÆIñ;yÛæ¬sŸ‹a¹iÀ˜ÉuШüÆ5ZR0üÕ£Wr¬ïº 0½GüÆYñ[¿ŒA„ØîjÿSn0&ñªÿmOu‹fŸŠv½’4}×M€©Úù ¶7A´uh§•‹Œ íª»–‚l7·–,õ» ZŽ8¶*¼>‡€ivæ·3m“õ1dSi1&­é¿Œ©1¾Yß¿¿zôJŽõ]7¦÷ˆß8?ó›ìÉzŒ¦ÎÚ Sÿi¦_¤oç·uÓ4’æäE¯$Mßu`ªv~ƒCÄc‰bt«}Lëlýâ#¬ÌL9¦ ï‘À+ŽÛ.„'iVüep¨)ÁZœfWR ÓhÛ3È­1qhÌü<í"z%Çú®›Ó{Äoœ¿!ÙÖ×h·²ò±§…©ÿ4ƒäîðÍrõèeÒ \÷&ªv~(.Äh޲ª1³UÊ}âg\ñ câèÈ4w¦ôÒ|ñ&š¿µG6X+åó˜rÓ€1qðp3¦è?ºí&Ää‚I¹(üh)G³â7Zó¢ %”{å2ÓhÛ3Þ‹_„[Àt*ÚEôJŽõ]7¦÷ˆß4)~Ç„vk_Î`Pò{b’›FŒÉƒÿ2¦Ö]9¢¿zôJÒô]7¦jç·—€"Å”{¿¨1yQrG,®o¢`­ä„mxæ“§r4Ûùmhp40@>Z·0 ·=Ãué£7Õrìlç.¢Wr¬ïº 0½Gü¦é™ß¶QY¬W ›¯ÏMƤµC¼p«”»yçÑ+IÓwݘªß¶(X“C$ò+c»áxqˆ¬!IY‰_\ߤ8hýµ âÉFô> L³ß¶V!ÚêNYKJi1&wßÇDâÖ”T:Û¹‹è•ë»nLï¿iVü&Š¢™œØI>] 0 F~žùâí”þêÑ+IÓwݘªß>ͯ´n&+c»á³³’ÉîËIÔ/Êb‘V¾Z Ú¨~ÇÓôÌïcLú;éoU4Xf¦Ñ¶çïKDn¬ºyçÑ+9ÖwݘÞ#~Ó|ç·V ÑÙ(X—ïüÊMÆ8\§rZÉ´ºrÃÝÎE/“fàº0…jç·¡‘}qô¿¶²d‘1A´/ˆMÆužç1iµƒ‚ØÜwÄ'Oå´ø­”¨Õe2½:¦Ü4Úöü½eƒp¶ÔWrìR´óè•ë»îLá=âw˜¿Ñ½ÐGÉGë¦c |3&ÀFWn8í"z%iú®›SµóÛ['‘­lZë"crʳ^´¬°¥º‹Œ “ ÂÞ&1P|ò®\˜{‚É+XÚ¦¼,ÇJÓ€1ùiL¶¨ª‘c×,“ó¿+Iç¢]D/“fàº0qµóÛÛ£]´&C?,¨2ési9±~KdLzò»rZÊ1ÛÂÌý“}L<+~G­’¬5+’­ïüÕ˜rÓh„{®|òÐè•ãSÑ.¢Wr¬ïº0ñ{Äož¿•¿z}Èê§Â’M°,L#ÆÜŒ)¹Æ‰ ŸŠv½’4}×M€©>ö„¼W8=âÊ1©£»v2+å¬Ù/"°Xeáæ_üaLZâ°õ£R”1Wû/À4+~Kôlckõ7‚¬] 06ñˆ¿'XDˆ™_Œõè•ë»nLï¿yVü[ÍèµVÒGQ~‰77ßß¶C¨Å˜NE»ˆ^Iš¾ë&ÀT¿½¤ Öà( ×ã‹!ù%^ï”ñ(#pñ;Jv*i¬É6"  .= L³â·í4BÍ!Ÿ`™›†ÛžåÖ˜b ÖÃïT´‹è•ë»nLï¿yz쉷}â–ÅœÕÿ¥iĘ0|5&j&Í5Ë$^Iš¾ë&ÀÔXx=[Sœpû˘lÄ‹H(ðéü^ј´Ô’W_}\/|˜fÅoýA”9‚–J’í.,M#Æ„÷)¥5S´J¹SÑ.¢Wr¬ïº 0½GüæIñ;r²·œ!dG¹…iĘ⽉×àêI“þêÑ+IÓwݘªâ7i1•Ø;GŽ=-Šß$v§”Qµ¸X¨>Ól2¯&úgÓ“£uyzáe;TUÂËœŸÊå¦c"Âk‚¥]iÓµÅ2^ɱ¾ë&Àôñ›gÅïä8}ȆM,LÆd[)/ÆdwêIOE»ˆ^&ÍÀu`ŠUñ;¤hS¤$E ´ÒŠd_9-‰m<®·õrVOåØûÅ!Ú‡''XÆé…—Á:²lí‹~†Y)—›F» Ü÷1¹¹W.^[,óè•ë»îLñ=âwœ¿cJ6„¼—²ú¿0 F¸ê¯ÏŸFI„¿zôJÒô]7¦êØ“c¹[²=ŰBzŽKýEÙl‘;\ícŠ.&¶™ìŸìüŽÓßÁ[sAD¥qÙ<¦Â4ÚönÆä[wåâÕÎG¯äXßu`zøgÅoëNFMe/(ù–”Ü4`LÀñÖ˜¢oÕÿ‘þêÑ+IÓwݘªcOì 1Lä5&a¶íp,bá^|0¦ÁE;ÖûΡ}˜¦ÅoEW¯•¸–IùÂËÂ4bL÷”T…‘ÖÃïR´óè•ë»nLï¿ã¬øí¬—Ï–Ü;‡¿Si0&à{¯Ÿi–µ¤9í"z%iú®›S}ì‰w1Jk’ iq÷Ø'bç7ñ’âxŠ& #HzRüŽÓcOœæƒ?V)­[˜FŒÉù[cºVWrìše’G¯äXßu`zøg;¿Ù†Šñq)_^˜FŒÉñ­11C£] žíÜEôJÒô]7¦úØýÿ÷¶°Ò¤l9`}ˆ 0d 6¬N`š¢°}Hî•‹³âw0êè‚õV»ì€¥06ñD¸îÊ…ÔècЧ¢]D¯äXßu`zø§Çž Ý]t¶-HRQÊýšFŒI È‹1qlõ1%÷W^&ÍÀu`Jõ±'ÄŽm8Yg}ß¶€A¢~÷Ö'X&BçXÿäˆOSšîüfÒêÒšÿæXií.ôéž’J¾5W>]íÜyôJŽõ]÷¦ôñ;M=A[ò—ôoÉÚJÓ€1Ù>ë›16hvºf™äÑ+IÓwݘêcOXÓœl!Ú¹Ü"cRPñ ÇýÀå™ßJ—l}C&Ë= L³â7[ã¢]÷П+ŸÇ”›ŒÉ‰\‡€ÒZžNE»ˆ^ɱ¾ë&Àôñ;M‹ßÎÙæ»ŠV ŠËMÆäßó˜”,4hvºí&b%–É%ôô¥°Íÿ`šžù-Î&ˆ·ñ0å¦cŠï»r ù­‡ß5È;^ɱ¾ë&Àôñ[fÅoòvDN)?•ËM#ÆH¾ŒIêâ7:÷W^$ÍÈu `Âò£;“m0ÅÞߟÆttmS /’>«ÖW4&Žíò/ÛN‚ç€éüxÆ9Ž.¯’B.~¦cŠþ¾]`ó9ëŒI©ê_=z%Çú®[º×ˆßçû=Nšä¬gÆs° ¤Y)W˜FŒ ᢨ±"Ý©hÑ+IÓwݘê3¿£NÛ–ð€¸xWì@/)²%^iÿô1ÚNY„ãZê“À4ÛùM„)Ùà:—=)L#Æ÷Ö8Æ×sìlç.¢Wr¬ïº 0½Fü>ßïqÒ$ úxwÂÁçcOrÓˆ19÷Õ˜<×K9tW;w½’4}×M€©Úù 6É‘mIvKí¶˜È è7$ök—x-ÚI´DÑoYx°”;?žqŽiù%d/•Cf+ÂJÓ€1éÓéîüvH-ÆþêÑ+9Öwݘ^#~Ÿï÷8iR 𶃔s¶¾©0 SwO ÖtAt—¢G¯$Mßu`ªv~+¶($Ù_r^!\aL$"F;ÀŽËwå²b9+2¹ð䨓óãçXLôgB»>ˆ¿¿Ò4`LúÝÛž%r}´Ž2Æ¿zôJŽõ]7¦×ˆßçû=Nš¤eÇZS ¦c#Ør˜5Ƥx¨e‰­ ×ÚÄ7Úý`‚Yñ[gCÈÑV¿¥Ü¯iȘ¾÷1S³Áü_=z%Çú®{¼Gü†iñ;’íe$«Ø³>¦Â4`L ÷ÖXo{sIs)ÚyôJÒô]7¦jç7*4¤c^BæUÆÄZ5LNŸå‹Œ)„¤¯×÷ßjÉ';¿azæ·€r?ö¼ÌÛrÓ€1ÑgÃógñgŸg-Ç®AÞyôJŽõ]7¦÷ˆß0+~Û“0x­•|v*W˜Œ)H¼ïÊùÏxŠZÒœŠv½’4}×M€©Úù­Ø‚HN"X¶/2&;!²­0 mBÐ"cBö½wb;/eLÓcO\r’]v*WšFŒÉñÝÇ” ùð»f™äÑ+9ÖwݘÞ#~äøÅ>«Ö)æO³Â4`L!Èõ=°ïS£óø¯½’4}×M€©Úù ØÖá*²¯Ìz;“)Þv}‹>aš ÆdÍ TK‚ x˜fÅo´íxZaÚÐ’ì®\a1&EÝ/cjL@ˆõè•ë»nLï¿a¶ó;' "ìCÊÖ7—¦cúÜû0&h]â…ôW^Iš¾ë&ÀTïüŽé@-?Y‰Þ"c²ér ÞÙàeÉc°“vútzr´îùñŒs̾íǽ}6y9+årÓ€1ág­ñgÛs ­RîjçΣWr¬ïº 0½Gü†é±'¤„~ B9ö´0“ûcò¡!Lâ5Ë$^&ÍÀu`Âzç·­Ýð¶'Ef ˜ìŶ\%Úàï×,í°*0MÎνÓN‹ßJHlC‚;ÈJ¹Â4`LèøîcŠÔ̱KÑΣWr¬ïº0á{Äoœ¿Á–½ê“5°b¿§r¹iÀ˜Hè>•³¤9í"z%iú®›S½ó;‘> “‚)ÅÕÎoQ†(‰Ø~s\dLÖm.‰õ¯¤µÎ“ÓpVüŽ.XO—·³þ|onm{Žñ¾]Á·€éT´‹è•ë»nLï¿q~ì‰Éb>] 0 ¹ç1¹ÏýÑZÒܳL²è•¤é»nLõÎïÄζN¢ÝîâÅé(úª ¬Ç;›®»È˜â±BáP¿fON°&<í"z%Çú®›Ó{Äoœ{’¼p²ñÐ1e}L…iĘÐß{å\-ÆtÍ2É£W’¦ïº 0Õ;¿“·éº’“%ñÛ^c4,f%²Øù탭ÎÖ:Ð)Y{ô/Nw~k9kµÊü¦Â4Úö,îÖ˜8´îcâÕÎG¯äXßu`zøÓ3¿­±ß®²Û _`*L#Æäî½òVɵÓ5È;^Iš¾ë&ÀTïüŽ£­Ã=Ön,Ö=Žôl\™aŒ+mãcÒ‡’r5I¢$\Fp~<ãÓ2éP–"ä / ÓhÛ3Á=]€}h´  üÕ£Wr¬ïº 0½GüÆYñÛ£ÖHŒ6ˆ²R®0“K÷©œÃØ`Lt*ÚEô2i®{Õ;¿£¦¸gÂAÁe•1Ù-9Ôo¡m:YZßdo½B‹8kgJü 0Ѭø­ ¼[“/#(L#ÆD_Vξuí‰ü_=z%Çú®{½Gü¦iñ‚ÓB¬¤¬Á²0 “]9¿ú¼>žfPIšKÑΣW’¦ïº 0Õ;¿cr`{GÁZd–€ÉSÐ:,’Ã`Ϙ5ÆS´¥rŠMI>³g©ôßi^üV e»ŠÓ0¦c rÏübàFÝŠv½’c}×M€é=â7ÍŠß‚f˜~´öÈ5¦Ü4`Lö˜?ŸfúÎjÀDõ蕤é»nLÎïä´ŠóVUáJóöÁ˜bp¢¿ub+^5&Òš÷Sûr¢£Mú1`š{b¿†~ñõýSa1&÷íc ‰cOèše’G¯äXßu`zøM³â··Î~½ØZ¸¬”ËMÆòeLá³³¨L§¢]D¯$Mßu`ªw~+0q²ýÁÁ*ªEÆHÒW{’´ÚÇd‡yb­‚JÙÂ1ߘž¦Iñ[߉èl­pÌg~¦Ñ¶g‰÷Éoˆ­Ñ:ôQ´Ëè•ë»nLï¿izæ·Ø$m-9’d,JÓ€1Àuó;Ù<¡0]ƒ¼ó蕤é»nLÎo6ÝÚÆRçÖ;¿í*nBô˲¸"Aÿ\Ž€!::>ÇÓtç··Áœ¼ ˆÌSn1&OüeL©LW;w½’c}×M€é=â7ÍŠßZS3JŒúålAa0&e4×~ʼnÀNE»ˆ^&ÍÀu` õÎo¶YßZQY󷬞ÊEg3¿SLú_¦þgmV zFéI` ³â·!,š¶ã$¿+÷k1&ïï™_ö[Ö)ø¿zôJŽõ]÷¦ðñ;L‹ß¶± @Þ.P˜†ŒÉ»›1wš*Is)ÚyôJÒô]7¦zç·1Ñê1¿v‰×*Ô÷=³`X§E 1)×2ü Ó´ø´H²‰ívÒ˜‰ß¹i¸í9ÞŒ‰¸Å˜Â¥hçÑ+9ÖwݘÞ#~‡Yñ’³ B&™Æ|}Sn1¦to°ÐGý1¶LôW^Iš¾ë&ÀTïü€h§<Þ6­jLú…¶çlmæ÷?ÿ’ôO6¼Ú¹'iZü6 ±žA Ÿù›FÛž ï^9[3ئKÑΣWr¬ïº 0½Gü³â7)·‰’Mqu¿ÀT˜O3ogf'c¢-`:í"z%iú®›S½óS Â6â.bXÕ˜ˆÑ–ô!ÚJ¬ÅAq"t4¢*·Ð7ìÑRn¶óÛJÒèÅ‘‚åoŽ•¦Ñ&žK.øl{n•rg;w½’c}×M€é=âw˜{b¿8è6BvbR˜FŒéZߤŒ ¤©1]³Lò蕤é»nLõÎoÑ›'£§5ñ[_ŒvÇ.‹“_\.Âì(%gwžùQÆ4=ó;z|°èùŠðÜ4Ú]¾§rØ­®AÞyôJŽõ]7¦÷ˆßazá¥Ò}¥:äŠK¼¹iĘ€®§YøÜ-“†¯-–yô2i®{×;¿½ãh$œcª—öÊÙ<Þ & /^╤l ‚]jñññð0ñtçwB[Ùâ¢ñ’_`*L#Æä¿SR5ÉמøjçΣWr¬ïº0ñ{Äož¿µ¶ŽȆø¸¬] 0 žf.Áõ4‹â±L§¢]D¯$Mßu`ªv~ƒ$­¨Ð"ö«ßŽ•!:qŽÏãñƤß/ýK+ÒŠðÉKž¿9»gƒ>ä›xrÓhЗ1}v-Ô€ ÿêÑ+9ÖwݘÞ#~ótçw"åþ œÄÎ;²é™ið4S·x>ÍbÄÏ ]%i®vî¦Ü4bL$×ËÈm`ºf™äÑ+IÓwݘªßZxÚjW“ q©ÁÒ60±Ø‰ZHp®ÄZaLm<ºõŽ{yVcš¿m‹²&„ ÎîʦÑîBJ÷©€4f~ó¥hçÑ+9ÖwݘÞ#~óÂÂK}À‚úü®\a1¦pÏʱQD )~·XþF/“fàº0Åjç7Xãwk¼²Å•‹Œ‰ì@Na0†µ –úLT¶¡ Ÿl°Œ³âwˆ\"Ðï~ʶ¤¦ÑîB¯ÊӆƠ¸èÿêÑ+9Öwݘâ{Äï8)~GÑÌÂDÇÂØ_a27ÓUÊé·#„ã(·LðW^Iš¾ë&ÀTíü¶.xï˜À›@¶¸‰W©€ÅCEdÛg°Æ˜‚úCi-­°äý“¥\œîüV ‰– ÷1å¦cúÌùþ0&» ãÕÎG¯äXßu`zø§;¿Q¦†øOE»ˆ^Iš¾ë&ÀTíü>®¾S´|úlN_`L>AP¾”ì¿‹—xm|•+®çgK¹…Îoç´×ê’²K¼…i4W^¾[Rl‡L˜¾íÜ¿Ñ+9ÖwݘÞ#~ÇYñÛ6¸¤lGa%›.P˜Œ)ò¿“;n~W€)Šv½LšëÀ”ªßmM·V¢'«Ó4¨5“ÀB+/>J9B‚¤•/†³ÿ)`J³â·Mù÷A鮣”oIÉM£¹ò‰ï>¦öîÂt*ÚEôJŽõ]÷¦ôñ;ÍÏü–`-¯.2äƒârÓ€1!Ëug”mäG˜îAÞYôJÒô]7¦jç·÷ÖÀvÕÍóʦSÖ[”x:·ÔùmÃCmM¦>ø!ð“,Ó¬ø­žälyÊîʦcJL_ÆÔZß”NE»ˆ^ɱ¾ë&Àôñ;M‹ßb²¯¼-nË€)7 ð9—ìŸÿ±•ë `ºíê ˜ Ó€1yA:“>³[{åäR´ó蕤é»nLÕÎo­¦’Xô¢Ü1 á!›` l÷–“#ÒŠnIü¶Îo‰ ‹Q윉†²û¦ù…—AëË(GU&ä¦!cún{NÁ5æÊ˽Å2‹^ɱ¾ë&Àôñ[fÅoÔDô«ïÑåß…©ÿ4ÓºC®«YS“1Šv½’4}×M€©Þùm§õQâÑ…d¢ã®F›{âlEøg´ÇcÏŠM)$%^jL³âwôIô{ÏÑéK¹Â4bL(ÖJJ®ÑÄ+òW^ɱ¾ë&Àôñ[¦ÇžD›CÒF^Êå¦þÓ,òLvfѺä®Y&yô"iF®[•ÝgSÔ™ly“]™åßxŒ ÖaÉKÀälàŠ8ÐÐ҄ÃŒéüx&rÌÚ5låò5ô¹iĘ \3¿µ”ûô4UrÌÿÕ£Wr¬ïº0‘{ø}¾ßIAø æyý_˜Œ >·UÆꌉܽÅ2‹^Iš¾ë&ÀT¿c²31¥¨¨ê†7Ö²™ßD *ãé¸c úv6§Ž’žþ`š¿µ.µþ!-.3ñ;7Ó·}BÄù0]Šv½’c}×M€é5â÷ù~“FÙˆØ&騼_òM¼¹©ÿ4c è.ÆäÐ×OLÈ]Šv½’4}×M€©*~{ÛÄ«% T™ømS¢2¯_”`RÆd¢ÿr1>(~ŸÏ8Ç"Etl{!»+W˜†Œ‰¾Œé³¥¸–cg;w½’c}×M€é5â÷ù~“&±KD›Ïaû¤€©0õŸflÇAç—H« ª÷1‘»yçÑ+IÓwݘZâ· ÅR°fH´ÔÇtÜSLч7³ ×]Ô˜¢mË´¦Ž6óìA`šïüÖo;2RÂ|P\a0&`¾O宲®’cw;w½’c}×M€é5â÷ù~“F?ýÎkmdÏ¢_ñ;7 Sò÷]9lL°$w)ÚyôJÒô]7¦ªø G»©-äHi©é8ñw^+‹$NIÓbD$¶ áÁ†ß< L³âwR5Á˦±dwå Ó€1Ùåæ“1%ImÏäNE»ˆ^ɱ¾ë&Àôñû|¿ÇI“”½:IÎ)…¥â(73 S û®œã0ù«;^&ÍÀu`òUñ£ÓŸÕ»@ˆkwålzç•) ;WccJvEC°ÜHŸ&?Ûù9ØäZ%q!­SšFŒ ý͘Že^õ;Û¹‹è•ë»îLþ=â·Ÿ¿¢m¸µ‹BÙÓ¬4 8iLD© LðW^Iš¾ë&ÀT{B˜ìáÎZÒÙ”5Æ„>E—Ž—&^¨>Œ)‚·ÙX áƒßçÇ3α˜l•28Ïú eŒ)7“?QÞ6éT´‹è•ë»nLï¿ý¤ømOUý¡]ÌÊÄïÒÔšý`¯;£G«Z#i>Šv½’4}×M€©:ö„qJZ  Àât¥[¬/tÁVêògrÉ c )p2y* ÄGiVüÃX¶/†¬”+LÆäà Զ›¢¡cúSÑ.¢Wr¬ïº 0½Güö³â·6ïH@ÄÇ_a²4 “'›1!Õ›ßÈŸŠv½’4}×M€©:ö$að¢UY”ÕS9›4d]‘pé¢Ý§Ép õ‹fÝãO¶ øYñ[ln­[pú„ù¦Â4`LÞÇp1&p­–*ÚEôJŽõ]7¦÷ˆß~Vü‚–`AÿÊÖ7—¦cJoÆäSj=ÍNE»ˆ^Iš¾ë&ÀT{Â!:6µ'ÀÅAqJ”Ñ&½ÚÌåÎo0$0h|˜¦;¿Ñ9Åg„¤iL¹iĘÜ}Ðh“–ëמÈ_íÜyôJŽõ]7¦÷ˆß~VüNìÐ+i>‡Œ1¦þÓ,ØáöŘ\J¤SÑ.¢—I3pݘ :ö„©Ï˜4͉ÜÒ<&}÷ld·P²nÂK¥Üg‚‡~Çlå(ѸQá?ÌŠß,„JÃÑÅð L…i´»0ÜŒÉvçÕg~œŠv½’c}×=€ Þ#~Ãtç·>#ÀYd Ê¿ –¹iÀ˜˜ÜÕùMŽc£”ƒ«;^Iš¾ë&ÀTíüæÀŽ59ýú¬2¦ u°³kvçî´•éáh_vÎÆ}>Ú` ³â·¤`½‹ZÙZVü–r¹i´í™î+: ½®Ñǧ¢]D¯äXßu`zø ó3¿í^VpÉF¥fÀ”›ŒÉ.ŒÉ¶æ6NLàäE¯$Mßu`ªv~G­3Ô¢MÏ_­ Š£5»k!èïÊy j `Žq(Pý`š¿í†lPÞ(óõM…iĘH® –JrZ'¿p*ÚEôJŽõ]7¦÷ˆß0Ýù§`/!Ì.X¦còŸ»Kø9WâVÒ\íÜyôJÒô]7¦jçwD»ÂK6IJabqPœ’­DÑ6¬°µn­1&Ak€’lF, ï³ü`š¿5¬ƒ=Úhä˜rÓˆ1ù/cÒlh=üâ_=z%Çú®›Ó{Äo˜îüöAìü(z’l}Saê?ÍHħ‹1 -éjçΣW’¦ïº 0U;¿£m°´¨ZšÇd­ª¨\‡D‘)ÀÊ‹ûÓK)²+©OÎü>?žqŽY?k®*f~ç¦crxM°ŒØÚö¬Ïƒ¿zôJŽõ]7¦÷ˆß0=öD˜¼Cƒ|~‰77õŸfv—ýº+‡Ä­›ßxÍ2É£—I3pݘ°Úù­è€èœØQáâ ¸¨°ä¢RDýjç7é«ä¨#ø^žÏ8Ç¢ò‘¤L$Ù`ÕLc*L£mÏ!\¿’þvyL„§¢]D¯äXßu`Â÷ˆß8+~ëc]‹jgLÌÆž¦cŠÄ×]9$Ï­¤9í"z%iú®›Sµó[RÒbÎ,/2&»ƒ£)#p>ø¥Îo¥[ÁÙ’Mf¶ÿ{láåùñŒs,êï`Ëîæ3¿ Ó`~èçñ‹¦æEq<í"z%Çú®›Ó{Äoœ¿õõ]]̶žñ˜ Ó€1q¤kðµÐ4:¿ñT´‹è•¤é»nLÕÎooM1Ž#‚ÃxV.¬O"¨µ c›B™Åo[Œ†ÎûˆBéIÆ4=öD‹q»¿çlÅ/0¦cׯĸ•c×,“=¸ðòüxÆ9v¬T¯í\ÖÄ[šså%Þ¬œm§g#Ç.E;^ɱ¾ë&ÀôñgÅofýú8GZ,e§r¹iÀ˜ ÑUÿ£kÍü&<í"z%iú®›Sµó[+1"Ñ¢ àA“MR°áÖ´p¡ÌÄo<Ζ$ÚÕ¯4êû_€iZü¦co²¡|‚enlâ9{—Æ„ç¤JŽ]Šv½’c}×M€é=â7ΊßÈ$Sˆ¢_¡ìT.7 “]†¸“2îÆtA:í"z™4×=€‰ªßÞ/¦Ck)§(³Æ˜¼ÓrŒQŸßÆzdþÅÇðФäÒ:˜ƒM×ÎåýÀD³â·‹Ä^´'Èîc–¦cÒ4¸·={}w9v*ÚEôJŽõ]÷&zøM³â·!8gCÉbÈîʦcr÷Ìo&lˆßõ蕤é»nLÕÎoï£ ¸çc¼Ïÿww}?rã8ú=E=Nㆨ¤¸À>ÜílwXÜf³ØÇ Ó©`útÝ=³ÀýõGÚ–Ë%É–}™:•Á̤-™mÉô§Evû“fÖ…¨»„ýNçj`R"aåÍâa4ã%i¥ó;Z ( Ð‘Õ œç©Á˜ÀŽ©†[šq~{wS—^ѱå®;¦ëq~ûµÎo‡b3 /Êœ™rEÓòjæ8XvÙÊfÉßÔ¥W”f¹ëN€©žóÛ*´Øà!‹HOǘÀDÒXÝ»vg|û™„y]”1­u~£ÆTkJx±—2çwÑÔ¬]8fI Z¨xFÇÂM]zEÇ–»î˜®Çùí×:¿½:Aä"PoÆ0MË«™#ÏiWN¾E7G³v!½¢4Ë]wLÕÈo°£<¶% o7îÊAW×Mø² ˜4lÜùÀÁxD°¸$0­Îùd¡4ÞhÔmvˆ·hj0&1‹“?_lV7L)‘w.½¢cË]wL×ãüökßzÜÐáŘÑ좩Á˜Æ³rVLõ™“ß~ðhÒ+J³Üu'ÀT/x)˜äƒ&Ô׬ܯ˜Èy£Y;¹ÏºÅǤ‰PóK˜ø’–~­óÛwœ—#j­»s`*šZµ S9+­]Èv˜ø¦.½¢cË]wL×ãüö«#¿­¼_o"{¢<\ oj0&±’KC‹›Í„ „ÎK/•¦ÑuÀª‘ß`AÉ oQÚ³ÙÇ„Éêq7ÄmŒÉé1˜ÐUâÓãv¦°:ç·y}Âä¢ÏRë”MÚ…BÊÖþ9K‰¼sé[îº` ×ãü«Óž³·(–µÉ¢r˦còàÒj&laî¸@H¹Lré¥Yîº`ªF~ƒFÆ8+4OHO—ÛlÓ®œúÌmäkÙÕ¥=qÂÕôëX´tÉ˰:í ëKÔí‘,µnÑÔ`L.ú´+œn…Ôu,å2É¥Wtl¹ëN€ézœßa­ó»«>ª)ÉÀÆŒ1M ÆdÓq-«Æ<cv!½¢4Ë]wLõÈoE£Ö0`—ÏlKrЈˆ>Ÿ*Ï®R&b ÊW¦!TÄ—¦ÕÎoÝ£„®r[‘(.ojU{0ú˜llYÓ±äÑÎ¥Wtl¹ëN€ézœßa­ó;ÈË;‰yË¢©Á˜¤cŠü¶Öù™ãoêÒ+J³Üu'À4ùí# oÑÐ&`êêøèX@) >m °Ô…,zd2í2¾ßL+ßÑhz.=½6«Ä[6µª=÷¥òzgÍetS—^ѱå®;¦ëq~‡•Îoâþ<—õšð0£ÙyÓòjf5Ÿ{bL`çJ„‡xS—^Qšå®;¦zä·<%=V‚šNjãY¹à‚C…‚Šh:9gL¤lËjíFÁ5¼¨iuÎoõ˜ ÕGRò¦c‚>à´cLJqft,%òÎ¥Wtl¹ëN€ézœßa­ó[ÀD–çBÌÒžMË«™˜-cT.ðPÝ£T<Ú…ôRi]÷LXüf¯™í1 ¼Dl8‡Ûg³ÖäŒF#3Él+®èƒ( VdÕ¾˜p¥ó; ÃÀèò2ôES‹1õÅzÆsÅnêÒ+:¶ÜuÀ„×ãüÆÕ‘ß(:ìÁ8>KW45S6í˜@tfÆ”ÃÎK¯(Ír×S5ò›Á¢ól…åaÞµ)“VÓ5ÞRÀ`7¦=® –¼¦%Ðb9—¦ÕiO˜œ·õëÏÎÊMjÏŒc>¦`fBR0å2É¥Wtl¹ëN€ézœß¸Öù-êå 4P¬†s`*šŒÉŒ‰Ìœ v!½¢4Ë]wLÕÈoµß[8týI-,µ„^¤Åzunc%^EÄòý²æ×»d‰p\íüÖCš ’ÊÈIÁ˜ÈžjÊüÌ„ `òhçÒ+:¶Üu'Àt=Îo\ö$:§½ yTnÙÔ`LÖ›‘1¡™Ëù)—I.½¢4Ë]wLÕÈou0‘×L­6Øm¦œ~~Œ–`ˆ~[>& ð-èÅú¶MHü`Zù­näÓ+Œò]¹¢©Á˜žjÎåcÂ!œ»^ѱå®;¦ëq~ãê´'Ö€“µBee»rESƒ1Á)ƒ%7wŽ S.“\zEi–»î˜ª‘ßb~êSw§xíÖºrBt4ŽÉ5&ðV“7F–­.né¢å›p¥ó;Êeoôè !ócM­jÏú+Rµg瀉oêÒ+:¶Üu'Àt=Îo\ù ž"É:²|ÌeS£‚3§ÈoÍ»:㘤1œ;“^*M£ë>€‰ª‘ߺa/„Ç1çÈn­’B¶mu§HO­ndL!08ެyÃ/Z‰—V¼\ÈŸPGй)—75“ÌfŠ€Ðã>3ÀD©Še.½¢cË]÷Lt=ÎoZéüf‰ ò:ò“²©QÁ"ºìpý9ŒšÒôíRzEi–»î˜ª‘ßÑ©ËÍr‘½Ûʘ‚W6ÂŒ&ÈÛȘB4lÑ;ôaª}0­u~£ ¥áà™óJ&JU,sé¥Yîº`ªF~kÁéPËÙ¡`ÌÆÔU&Bl‘IÝXWNf(‚fH@¿(cZëüŽ$†=ËH8Ë.P4µª=§ôÍo5ÿ—Ÿ¦Á£]H¯èØr×Óõ8¿iuÚ“¨ù_QþgBæc*šŒÉG“Á0ǘR.“\zEi–»î˜ª‘ߑտ$ÌÅjÖÒÓÅ15Q“âk¼AÜäüîÎÊéñï\¤š• ¾˜Vçüf#8kh)Û`)›ŒÉ†˜tÌE°3A¼”yçÒ+:¶Üu'Àt=ÎoZëüF­¨ÁÎü“SÑÔ`L.pbL,,»ÛÖ-•&š›ºôRi]÷L±ù 2ZûL“poŒüÖÌÄšƒšôÐã¦*)z|8•ùs®Ïù})`Š«ßÎhD5‰a ˜SÞÔ`LbãŽyåõˆs˜bòhçÒ+:¶ÜuÀ¯Çù×F~{§g÷¬ò-eŒ)oj0&\:š%„¡ÿ{Ei†pîBzEi–»î˜ê‘ßÄ “ÿ¢¦©Ú#Ù1&Œ1rdYÀEÊÆìºµd(˜ÇKæüŽkß Ôä™(r¶+W4µª=‡±ê¹ vîtA<Ú…ôŠŽ-wÝ 0]ó;®u~Ë÷.ëªã AçÀT45 Iö·6LƒG»^Qšå®;¦zÎo€µ£‡7fÐqà¹wÅn+ßDbÇG2b :ï.™ö$®v~£Ð?ãÉx‡¹ó;ojTâAˆ)ç—sg"¿còhçÒ+:¶Üu'Àt=Îï¸ÚùMð$–ƒqy•”¢©Á˜Œ¥´cB²œÍSòhçÒ+J³Üu'ÀTÏùm¼Õý11ãxS¦>»€…àƒPÄèc;Fòœ19`²$72¨;÷’À´Öù&04$¼7dÀ”75“&NŒI“ÏÓàÑ.¤Wtl¹ëN€ézœßq­ó[^ƒ….'¿ó¦F]y‹]“×}%ìÏxÕ€iðhÒ+J³Üu'ÀTÏù­),5 €C·µ¯¾ƒÞ:ƒØoˆÎì¬è(ÖéÙá¾p”¿0­Žüö]IÀèm¤¢ }ÖÔ`LNV¼Ä˜4Æ}˜R8w.½¢cË]wL×ãüŽ+ßÄшuítgÙg¹rЦF®Œ]ä·~! 9ÊJ¥asS—^*M£ë>€‰«‘ß`]Êc #Æ­ù˜4µ®–îÍm)J7„ ¹ÕB€K&ŠãÕÎoYÁ1ÍFžG~çM Æä(ÒȘfó1qòhçÒ+:¶ÜuÀÄ×ãüæµÎoG–£'3劦Æ9&éš“÷¾„«(ÍàÑ.¤W”f¹ëN€©žó[ì0á+Ϊãb[15ŠYpÍk>'²aCÂð> ÚFeLž…b^4Q¯u~SDc<1y¢¸¼©UíÙAÚùuç2XðàÑ.¤Wtl¹ëN€ézœß¼Öù‚'œVœ°ç[¹eSkÇ»ÄùʘdíéË…W”fðhÒ+J³Üu'ÀTÏùíL §õ†œßècMôgÈj(á&`ÒõA3@±êlºh‰p^ëü&bˆ“÷2šÌÇT45tÌ3Vâ‘ÅjÆÇăG»^ѱå®;¦ëq~óê‚—ÜÕdd10È›Zuå\ç˜ô]]9sÀ”ªXæÒ+J³Üu'ÀTÏùí]ôÁ’#èù-Œ©«ûÕ ³6•oR‹Z³}“æø¾¸ßÅ€i­ó;D1í5¡¶'Ÿ¥=)š:y<]`#ÌeàÁ£]H¯èØr×Óõ8¿y­ó›8¸ 0" {cR65ò1‰ýïÆdúl–¥<Ú…ôŠÒ,wÝ 0Õs~{tAh‹°˼¡feǘ¬§h¬\²›Ê7™ÛˆVk¤iô¸úK. Lk#¿]4,b>’™rES£öeÁújÏ}‰ã0 áÜ…ôŠŽ-wÝ 0]ó›WçüBü­|÷š‹ý˜Š¦F“Ö1“ì]T®/”&˜”È;—^(M«ë.€)”¯®gLb‰Y-£-6Â6`êBUÉtGKÐm*þö–ƒ5b“_’•‚›Îï‰Ò óÝV¡cÑÉÒƒ6rüöðüú«,1/¯w¯Ç—îþoO_îžþ§ÓÜç‡ç¡sÒ‘òt¯7¦K?xws8ûó_§—ÞÉoßäÁne´ÿý/Üws¸{ü¤ÓÏoú¢ÿ÷ðV_ŽõšÑ)vdýöà ‰üÏÛN'­“¿Ú9J´C»Ó‚4ä=ëúy# mUâ ÇW$º¡]Œ3BöÓ»+à8h•t¥|Fa”£D?´[¹É`ãýï°Ä`:·¹©Kb“dC/Ѧy있¢áa£»ŸG/ŒIÍJWŽÚÉb©5‡T{Ǧy½™h¢V:ÓylKóóì’™^¢;œô1Ô{Nc”+²~ ççŠ?z%ìgLÓrŽ“>’Ñp/Œ§wíŒÕ®–N]{D»Ò»N§‰\šGc@bÕÇQ"áåÀq~Ô¢ iÔF‰I™5eóIÃQvòKŽã<öF‡ŸÌcw3‚?Í£¦9b _}F}—ˆ ‡á›è—ŸÌ£kYÄL<é£ü¬ssHáõpP’8¼k˜è£Æº²'}eŒ‰fG-ÚaÇQûQbÒG2NèI„ÓÙ2È/÷w¯ò˜“‰r“ŒØÍÛ(‰\®ßž^^ß~{~º?¾¤/F ³8}D/,õüÁfRÞÿøã»ŸÞŸ¾ áVñ« ’©˜7ýmïÕñòüëãáŸwBÏ_e²…vª3 èþ ¿HþöîøÑ8ã×oÞüñíïúçúDÿù×;üø×ÿúóíï/ýfºcñ (TDDFPT/Examples/CH4-BOND/CH4-BOND.pw-in0000644000175000017500000000133312341371500015045 0ustar mbamba&control calculation = 'scf' title = 'TDDFPT CH4 Test for projection' restart_mode='from_scratch', pseudo_dir = '../pseudo', outdir='./out', prefix='ch4-bond' etot_conv_thr=1d-6 wf_collect=.true. disk_io='low' / &system ibrav = 1, celldm(1) = 20, nat = 5, ntyp = 2, ecutwfc = 35, nbnd = 8, / &electrons / &ions / ATOMIC_SPECIES C 1.0 C.pz-vbc.UPF H 1.0 H.pz-vbc.UPF ATOMIC_POSITIONS {Angstrom} C 5.00000000 5.00000000 5.00000000 H 5.71000000 5.71000000 5.71000000 H 4.35718591 4.35718591 5.64281409 H 5.64281409 4.35718591 4.35718591 H 4.35718591 5.64281409 4.35718591 K_POINTS {gamma} TDDFPT/Examples/CH4-BOND/CH4-BOND.tddfpt-ref.gz0000644000175000017500000054754112341371500016511 0ustar mbamba‹ò>OCH4-BOND.tddfpt-refÜ]Ûr9’}÷WTÌÆk«¼à¢‰~蘾ìLôÅÛvÏtìK-Óc(RCRòØ_¿™Å*ÛT`6bSt·$ËÅb%2ó <êôõ|·}»[Üt/¿þúÛç/»û ºˆ±ÿ—nXìûn»é¬ÿvù Œ…nq¿\vö’±{ô¨‡½¼^í»Ûá2ú£´ê¶oºÃõ²ÛÞ.7ÏöÛ»ÝÕ²ûï»ÅæpwÓ}óâùÏß¼xñS·¿[–Çk¼Ùîº ÿ¾_ÝÜ­‡•¼¯\åfqXîV‹õþÝíz¹Ø/»«­ôõ‡çÝw«Åf³ýðaÕ-Ýb}ñ´ûËE÷üúýþâòOÛÍëåfÑý°8È…:°FfÝc0&>ùã§+u¿üü}w}8Ü^~ñÅ»wï.†ûy¶Üßî–ûýöb»{û‡§Ý±ÁjÓÝÞ½Z¯®ú•‡´ëµÜ†_,v«ýjó¶{³ÛÞÈ£çòn»û»ÜÇv·ì^/‹ÕZ@‡ãÕ2ïúÅ?åÅíõíðÈŸ/v‹õz¹îî—»½>¨Ç?<ÿó“§Ýîn³Ñ7•ßè+¨Y®ô*»ý±áÏÝtßuûÛ…Øãõê~¥/»öÅív»î¾ìÛ oó¬ðõyGÿ†®ôøåêfÙ}½”. &8ÈO›ýêð¾ûöns¥Ïh±îž/w‡»Ý«£±_^/·»÷O†‹½¸{Õýõøé.;s»íž~Yv‹ýöÍ¡{ü×…ÜÇîÕj}xÒ=ß/ï^ooå©nÚ¹zôŸ7o¶—Ý]o¶ÍÎ>•/ _°»_¬ï–û£-W›Û»Ã~ß7è¿â>ÑDýðü§Ÿ_~õãËËî×?uo>=‹¥\Mhòú³&Ýå±Í7ÿ¼º^lÞ.Ÿ]mw»åÀþ%æzñýWÒ!þGþòãOßýª_þÔ=î¬ü1úçÉp‰_}öf·¸úÔt|}9þ`.Œ9‚¿Ú¼—;Û wÝ×ß¾”îúfµYõMß­Öëî•vžýÕb÷zùzè=5Ÿj\½yìïÚå¯e¼x¿½ëvKé¯ï»wÒ·=:}ÿîÍj½ìþëâöóûWW¿<ÿöRp÷ËñÑ<Þ?é:ûB.±ÙînëÕ}ÓS¬>ŸÉJžaº›<FµÕÕß÷Òé;–ò‹›íöp}¼Þßúoß=»_^õó9HPÇ+ý°úô(™ýçß-†Ÿ²;ù)†áJ‹~º’3Ÿ·d¦®N~@64Òæf„¹øÙwkM|x!@|òC0ÖlÞ>Ãñçß™ùQ÷‰§ãp²x«ù“-:¨wò—ûe·ß®ïÆ]ýÂrõv¹é)¢cÏ«õòfèê‹nß÷2Œ¿ÝîV‡ë›]în/†ÞõûÅæêÃvß­W›åb'}c»UCío—W‡<ƒ«Åújð"Ç?Þݼ’î,ï?¶îNkå€eéþGìß;F/uH’Ñz!ÿ߯d¤’ÛŸxZˇÓqd©và§Ýa÷^‚ÃV¹±[¾v(ìã­}~GÇ·ùnqs³èn·«ÍáÓÇ=þÓz÷Û»7WJºßÆtÙ) ÷×2Bȿʽ_þ6øÁ…úÉz’ÊMŽŸPzñA†þ#ÃíEp6"R0`ƒA7P½¼ÞùÇgºÝÞŽ–·ž÷Çgvù Ñû`ÇqÄöÉÉë›ÿ4fú·Ãÿ¥1Ö7–'¹¸½]¿ÿm½ÚÞÝKG“Hâ²ÛH×ï­E¬³Îsm¦ðz%²†®½¾½^<nÁ>ùòÌm½’ø ¡ Pë­“Ÿ=³ÞZþ­v¢2è¿zã•)×c`ªÇX ´‘ÀœÞtiyvÆ6xOBâøÍ3“è ¿ï1Ú˜Ø;pØ`à\ã+B¹Q¡ì¼LÖŽ)aÅóÐÿ§.›³"þ[óþÄŠXnE:LŒc¢ ÖYð,P˜°âyh#\¤ß[QäѸà-c¬³"a4ÑÇG¨á¢6ö(€#GòÔª¸HåVä£iˆ!² 6Ær?âLYñ<´.ò|¸ÈåVt½iB0Þ;ñhÁRŠç¡pÑMYy L$‹ÖÕXñÙE¤à4蓘^éëüb”7ŽÑ RCÖ©žXÑ•[Ñ &®ÁI‚A@1aÅóÐF¸èçÃE_nÅp$ÉðQú 2¦üâyh#\ S~Q\³#¦(ú*.Ê'F'ŽM|¢!q¬ê¶²¢4Fö6GC½_<ÛøÄŠ¡ÜŠñH°€Ñ:ï˜ôW +ž‡6ÂÅ8.Æb+Zs$z»eì×(ÎO[1mƒ‹öwϲ÷‹½Œ!Òù¬8'¬ó‹0ˆûàèÑ5\ì»h˜£Ü©áâñy—YÑ èÅ6‰5mƒ‹öß[':±b¹vcapvƱt@üV<m„‹ÚøE!c„bô†ë¬(œ‹(4Å;Öå‹Â^4A"ˆè<ÕĨ¶\»±8Œ} ’?°ðß&¬xÚç£ÝØríÆÒ@0·%n‰%¬xÚ'´ñ‹& ÈH¤i¢‡:+‚·V܇aK¡JGÕÆÀÎJ,ˆ¬ªW˵ËcàɆèYÚç£ÝØríÆ‚ yg¥£YFùž°âyh#\œÐn$RŒ.’—{§\•_”Æh¢$‹–M”.›ò=ˆQÑ “ ™|ªbÔríÆ‚L0:âˆÃóƤbÔóÐF¸8íÆ–k7vd‚Q}BS +ž‡6ÂÅ íf¼iIr $à´•~‘ kkmïc¥v#%ˆÖL¨\ÅÅríÆ‚Œ¼ Xä.š„ÏCáâ|´[®ÝÀ(ÈD'‰ƒc$übÚaB»y¦ÓiF¼€ÑXQ\T_Ôè2x¤H’'ûJíFGô1²¹ÕpʵÇÈY§Ãd"_Ì@Ûà"ÌG»ríAe˜$ˆ: –°âyh#\œ®»qšâŠ{³†*µâ(9•x6ã L6Ì|0×ÏÂÀ(Ѽ„ÉÈU1*”k702°}$¬xÚç£Ý@¹v£ ã=Û~¦"ÄÄübÚ'ën$·åè /ßV白¸49xò®íÔ/JcGÎDÉr6À=±b¹v£ #§¤–9P"ÓÈ@áâ|´(×n`d}ô’A€”ÏCáâdÝ%‰!† =/TÏi0j¹NÄÀN~¨ó‹* JJfµP X_ÅÅríÆb.”DÓ9ùbÚç£Ý@¹vƒ #œåhŒDa>1¿˜6ÂÅɺ‹ÁFòB/ñf¨ó‹žÐ’wÆ‘ªbÔ¾±¼!Y«AUi7P®ÝÀ ȸ Y¦*n/£ž‡6ÂÅùh7P®Ýà ÈHWE­Mì§,¦­˜¶ÁEœ¬»±h%áC âÜVÖÀ4Ö´Bƒ6K§S+JcñŠâ“%ÃŽ&+ü|nE,×npd˜´`œ¸`—ˆn2Ð6¸ˆóÑn°\»ÁAÖµP2vŠ í&m„‹“u7ºfJç$œg‰Í*uÔ(qƒ\œC¬Ì¥q4á !­§ª˵‹i¬dÃàUMUOe pq>Ú –k78 2%—^C>¥†g pq²îÆêºvt½—©ŠQÍEßáPœbd¹DåübÔ3ñŠ8e®âb¹vƒ£ #¹©!J(ph#\œvƒåÚ ‚ ’'#œe²‰¬?m„‹Óu7hõ›®$䪹~ilÈ8Â|ðGí¦p!2}D4΢w.×øÄŠåÚ Ž‚ŒñÀ€,ñ4&f‰3ÐF¸8í˵‹i¼  8cÊ/ž‡6ÂÅéºãØG]ab ²îÆBuU I÷ 5\<6öÚJ ÈL˵qu6j:Oɸ ´.ÎG»Árí†Æb–,ÐK ™FÚiºîƈG ÎhÖˆ¡vÍ”eÉô\ß2s¥_´ºÅJz-Ã@_´SÌE*×nh\Ä*Ì*6%¬xÚi>Ú •k742ìѹhDs©ùÅ ´.NÖ݈C´HÂêÈÎR9z¿hc°Ù†èä*¾Ò/Jc•`]$ Ä*.–k74Ó\F¡=Æ„_Ì@áâ|´*×nˆÆICmt½¿Kqñ<´.NÖÝDMYcTŠ®í¸–Xœ)b`q$‘²aæÃµÄ2øÀº×Ä:¿X®ÝÐ(ÈÈPã¼×ŸÈ42ÐF¸8í†Êµ‹i1’fÚMÚ'ën„Dºz%Zv¶‚N½_¦×¹wëb ‘qhìgÐÕq±\»¡Q‘;dÝWJ¼]ÊŠç¡pq>Ú •k742`´,Dc8é: +ž‡6ÂÅɺ› 7 ÖݨÇC6R|¸~!’ÓiO¶¢ñqý"¢‘€Ä?Šªâb¹vCc1³Á;ÏltMÈ´ÏCáâ|´*×nxd$}pVK6}j]Úy²î&X‹ AbEƒ)ßqï)F¯3 î*’M‡àTˆuÎTq‘˵BQà¨ËƒCô í&mƒ‹<í†Ëµ‹i öëK%bq 5m„‹“u7º‰¤ã¾Žm¿¸Ê/úà£-ž‘ˆ Ö/JfF­‘„µÎ/r¹và ÃÀ@óˆ‰|1m„‹óÑn¸\»a‹L"s†…„v“6ÂÅɺºhIr7Ý*TqQ]›Œ=$9JÖç«ýbTÖ‘¤g³…'V,×nxdtâ…làÔœFÚç£Ýp¹và cÁirBj± ´.NÖÝx+Tb­R€Ìf«_øE‚À^\jÐ ÎÚùE-÷ÏäBäì(pbÅrí†AFÒR#©C ˜QÏCáâ|´.×nx\呜º<6&Qɘ6ÂÅɺ ñÁ‘ \QÆÖûEL„`b­_”ƨ{¬b€ª8.×nxdH^’Ç‹e$tÔ ´.ÎG»áríÆ™1 ¤_t3ßÄ,qÚÝdÝ#,\ðºŠ+ÊØŽ~Q×hx­'•Q®j®ÿؘ½ä™Ò[¬ªsåÚ™ Q'#i¥i"ëÏ@Û࢛vãʵ7 2Á1:]»N©•oh#\œ¬»q6Hà½þ"Ù[­_¯Fª«ŽZчƽw.:Ì+¸'V,×nܸÊ X#–‰©]‹2ÐF¸8íÆ•k7îãÄFw¶ŽÎÛTt“6ÂÅɺÖ5ˆzòxoCvÆý¡_4*Ú€ÓUÁu1ê±±s,á±–ˆWŨ®\»q°nï©cc’PBÒk‰U«æú}¹vãA†…bb]_šª*Î@áâ|´_®Ý„±˜F 1œfäÑMÚÃdÝ Y‰M)HÚˆT[w#ÎCò=olˆ!/…>\×ï%–g]råc~fós+†rí&|,¦qš"“ÄŸ +ž‡¶ÁÅ0í&”k7áãĺÔJOEbNĨh#\œ¬»A¡%‰Ç޵¡µëúÉ?G£K cí>pÒø¸I·agŸX±\» ƒ £ç ©Èd­IÕÀe pq>ÚM(×n…mºã©×ƒSõ¨h#\œ¬»ÁЯ`÷Ñb_5§¡®u^Ľ‰s­ö‹ýâ2yR ™vÕ\(×n ÈH®§RK$­‘ø´ÏCáâ|´›P®Ý„qË.²c€˜ŒnÎCáâdÝ :–ñCÒ=댯ÙâôèåEâ¦|¯ˆÖúEi+­å :—-Ú9±b¹vA&’‰NòÓ˜Zן6ÂÅùh7¡\» ãB¨@ÑCÝP*‘õg pq²îF²"C¤.ÙX°Šð¡_´–ŽñâÝjëQ¥±ó†¬ µëúC¹vâP¥5ÂÁ[ã=Æ„ÏCáâ|´›P®ÝÄQÑ€E2* =!±kQÚãdÝ RÐ"4r}´X«£JR¥;QHǵjçAcSÇĺ´¿*_ŒåÚM7 öäuãÉàCj×¢ ´ .Æùh7±\»‰ƒ cž¾«¢¹Äˆš6ÂÅɺݹ­Ä %ù«ÖQA2Mvd¢p²Ö/‚‰,ëù6ùbÖ+–k7q,¦ñÄZh*I ›„ÏCáâ|´›X®ÝDú˜ú^ï‡:‰!m„‹“u7Â@=/ÒêBBS·÷”Ñ­¿I'%Œ âJjçûÕË: DQòÍ*.–k7qÜÄÆ" £“©‰Yâ ´.ÎG»‰åÚM‹idt$”Œ>"¤¢›óÐF¸8Yw£³õ˜Õ—CÍÒüá< qˆ¤;K@P›/JcÖóœ ÊŸ*5–k7ÑI  ì,8¹ÏTtsÚç£ÝÄrí&‚ M¥dä‹)¿xÚ'ën@|R0Òñ‚wà«ý"±ø50@lòelý"éyßà 6è8±b¹v?üm£uZJcS§¢d pq>ÚM,Ön¬BYì³)u¹ì”sÐ&¸hÿ,Õ/êlé„(emý"-.\»NC«t ¡jÕþÃó.³âXL£ ¨Á8$VÛä MpQnr.\žw™GAFwGê§ÐRçLå pq²î減—TÑ4UµáêÚŒÄåÒ ôĸÚuýÒ8uyäwƒ<±b±vcÍ È÷!Ò}yçLå pq6ÚÍð¼Ë¬8e¢·ÁºÝÙt¦‘ƒ6ÂÅɺqgÁªêû©ÑJ¿h¼®ò#ùÈ’eÕî'9Xü_îÞuËvW}¢Þt½ÿ‹…Ó^_g6t~1\—U½ªEåœÆ¤@ ¹s¸ÇÌÆý¼÷vñ!dŒ´ÇIÙ©³þ•é!Xü ws?ï½]|Dl $Š jÌÀ­LÁâ°î†"Å-NŒ_Ìö/–Èõ0ZÜW™ ¾GlŒ›ÉVK.FÝænb;îÂ6Å„ »î gÑÍ»é!Xü ws?ï½]¼ ™J1˜F Xú,Óx7=‹Ãº蛆K,‚uµýõ‹Ê\cq© $ˆ¾ jÒÝâ³eîïç½·‹1Çׄâϸ•é!Xü ws?ï­]¬Ïð(SÌbª:ÑG]™žÅ:¬»!bÍ jÖ))ýñ‹ÊXº3$ð²~‘ÂñˆÅÉ¥´îbþï]¬ûÜM­OSbAô‰NÉ·0=‹õ;ÜMÝçnêMȈb¼ v̪Wø¯LÁâ°î†Pg⥒CË?Ù§áH;&úP…k›ìíÈ/ÆbbíD`\-þµ‹ûÜM}ˆ¥£î;’âqÝÍÊô,~‡»©ûÜM}¡„ÔPÙFq€OvñÝô,ënPÝm]d¾î®ÿ½‹'mvqÖ¯æÇm,^‹[·¨žkýºÙÇâ>wSoB&âMjjøšu†•é!XüwS÷¹›z2ª˜Ü[c˜g?ÞÅwÓC°8¬»‰ Ó»rc009 ÿpmD&(zU‹·7é¡ÞO‘mZ8È‹„ÝÇâ>wSÿ þ–83",ne¢ ¶2=‹ßánê>wSŸF(‚ªvDa˜ç6ÙÅwÓC°8¬»©.ñg…RiOÞi„k3“Ž›”8ÐÒµýñ‹«ãI²¤:§°¸ÏÝÔ›A»ÄÏé×¼€ñ.¾›‚Åïp7uŸ»¡§˜¤F¼pqúË„»Y˜žEÖÝÔîq@IU•ÿ#é#Y¬?w„¾áÚþøÅ€b#hÉb"·d°HûÜ Õ`,ÐŽäøÀ“|qazé;Ü ís7ô2¤5ÂÁ%ܸ#|ez‡u7Ò­ˆâÊ“ý‹'OW@9bÜK #å¹$>p TS1*ís7ôÿDlHúu2QJY™‚Åïp7´ÏÝÐCÈ@[Zg܃MvñÝô,ënjC©j´¹éZIÿ¯_lŒFÌñUNûÅÁ±ÅÏ.^x ä_»¸ÏÝÐ3<Ê/z ŽÜg»ønz¿ÃÝÐ>wCv“¬o©ã›ä‹ ÓC°8¬»UáTZµÌ8u×®­£Íâ*ü«½¥¸,–ÂNT\iy!òk÷¹zn`c¨™LEY™‚Åïp7´ÏÝÐ#@Ü»DÈÒ"K“]|7=‹Ãº›ˆ©»…/ÐÚ(‰òî›GE!+¹X$œ)î‹‘ ’†ŽZ._Üçnèå½Ú#—º0=‹ßánhŸ»áòÈŸz{ˆk›Ý/LÏÀ"ën*F=5mäZgä†ên =ÓM;!0ÏÖÝ $1pYc)©8Þçnøi„’Ø’®E©Ìª§¦g`‘¿ÃÝð>wÃt‡,=Þ1CR3©žZ˜‚ÅaÝMøE‚r…‡‹L7[a-ŠJ‰ªzVï¦T)GÉNjFøý¼÷vñi„ÒðsóéhÆÀ-LÁâw¸Þçnø&dŠk¼1ð}Vw³0=‹Ãº›jnI gS¶¯?þ?VÃFRÎê݈¬ã†²Dº™Ãâ>wÃÿ¡0ïÕ¡wÃO#T|;#¨ôÅÉ1ÙÅwÓC°øî†÷¹~¡:÷Ò00´Of¾­LÁâ¸îFãü üR«å¸P¡áÿ»8êv,w§ÅŽißÖ¡gqiOms7¼ÏÝð#bãªQ¼Ï³ê©…é!XüwÃûÜÜÅ4Æ8¶ã#뿸0=‹2®»ÜHhК[îNã?ÿçÚÝ1w¢³uéÌU½’c¾¸ÄêeŸ»‘G€¸`Ì$æw”‰²æÊô ,Êw¸Ùçnä_1MäñÐ!Ÿu¾-LÁâ¸îF„¹uèÎ$ý¢`Â7zŒÌ=[w‰b+Úé§?)…Å}îFâø‚øqL>=QßMÁâw¸Ùçnä n?‰0®ËDåvezÇu7ì…¯ŸÅK˜íÓàZÀqD\§%¥ü"Ws¹*wÍùÅ}îFžbšvÅÓ®D³ž©…é!Xüw#ûÜÜ„L¬È"™ŠÔf–õ/LÁâ¸î†M„‰*î5’~‘µjƒ8jÑdŒz-¦æEP0HÉuŸ»‘ÿ'@¬‡eGãòdßMÁâw¸Ùçnä&d"~jh—eê4¹ë_˜‚ÅqÝ ƒ mM ׺¾åûãk¤˜h'Ä`áukþ¿X›"3s*òÓ9¹Å}îFüŸ³COŒê¶É.¾›‚Åïp7²ÏÝhyÈQ0“pý,.LÏÀ¢Žën¨UoñÒ.ªeûú!ѹÄ{©r–G%ŠB«‹D¢Â¢îs7úÓD$ŽyŠsr²‹ï¦g`Q¿ÃÝè>w£7!ÇD ^¼É.¾›‚ÅqÝ …W¤~õ“'®ë/¿ˆÒ[×GœqY†™übéa1-*­E~íâ>w£|“¥Z½EP<©»Y˜‚Åïp7ºÏݨ<-~çÍ#¯™°á ÓC°8®»A¤¨Ì­²Jî®?\[ $I±ÎªY5^õXl^U),îs7z2! 9˜[šõ/.LÁâw¸Ýçnôü­˜7Ü1˜~–i,LÁâ¸î¦B¥P|v3MÎÓè­_Úw¬ñÏ’äQc±³š=¹jª—X÷¹½ (¹Sxq©Ü.LÁâw¸Ýçnôi„2úIœþ\fùâ»é!X×Ý #!¼¢iS¯Iµ{! QºSü’ó‹±8~.¦8nFRXÜçnôßð(æØ².6‹QßMÁâw¸Ýçnìÿ2^¬o2›§±0=‹6®»ÁÀHÑFâW4u×®­Gl ½-uQ]ÊGýñ‹höd‚BªPMõ/Ú>wc7!#i¾»¹ù$ºY˜žEûwcûÜÝ„Lé\)ŽHŠtr¢.LÁâ¸î㥠š‰Ã=eõnzdVHE½§óÅXŒ©|Í©j)}TÛçnì.¦‰ÂÍØirK¼0=‹ßánlŸ»±§˜†P6 Uþ:«d\˜‚ÅaÝk£Ò ™t)–ɸüb¸ÓÞ‚9å¬_Œ4ÕzUèOSXÜçnì †f-xÛ™ÜÂô,~‡»±}îÆžáQ\(¢Ïkö÷Ì/¾›‚ÅaÝGjT¥FæuÆ„ô÷å»G²Ø%üH.F½{Ãü6FùgÎ/îs7v7B‘4±ˆ[â³ú¤naz¿ÃÝØ>wc7!‰ƒmÆ&»ønz‡u7ÝÍÍA‘¹$Fb\~ÓÞŒœÊ–ÔÃâ¦lÅ’Ë÷¹» ™ˆ…Ñ©ß,þÝ„G]˜‚Åïp7¶ÏÝ´›i(*©â"3…éXlú›®RKÞ{ÄÕ™ÄË/iÄ—ŽÊŠI¿H*n½X«S:pmŸ»iO1Å©ÃÁ'ŠÆ»ønzÛw¸›¶ÏÝ´ƒ¿ãŒ„”':g'»ønz‡u7‘ãŒ4¼ZÁÍ}Ò/^ãÐ :¨KÏÝiü,F7¼bm)¿Øö¹›ö Ь–J°m¦º0=‹ßánÚ>wÓnBæŠYª°QÕÀ-LÁâ°î¦£)ái$I¸NËùEÌVºˆÔuÊ÷Ç/VŒ:ˆ[¯j¥÷¹›öˆØŶ„Ïãi/ñÂô,~‡»iûÜM» ™ÁBˆWŸu¾-LÁâ°î¦ fñòHûDÓ~ÑZW…ªcœ@Ù|‘,Aã5f§°¸ÏÝ´›‰ï‡n04Ãâ»é!XüwÓö¹›v2hêi¿X—Y¾ønz‡u7¯ih¶ÿ˜ÍYk‘ŠF?‘µÜð¿‹¹wÔÌiMÂþÚÅ}î¦ù?g E4>Ë4ÞMÁâw¸›¶ÏÝôGÄF!BÁhÕknazû°î¦G„Yº¡°Sß’~1褫XD©Y¨?‹›1uÃåú4ú>wÓoB¦Õ8!+kdóm’/.LÏÀbÿwÓ÷¹›þÓX‰í‰ñxi'»ønz‡u7¨¡¥HÌÌã'ý¢FÀÒ5Ù¾~,nÖLã€ôžšÞ÷¹›þˆØ8Rsn:ÝÅwÓC°øî¦ïs7ý&dó†¤â•™UO-LÁâ°î¦CNQ¹”`–¬_Tà©z”Qk–G…ˆlüd‘"u§Ñ÷¹›~2J ãÐÝd†ÅwÓC°øî¦ïs7ý ŽhÅ=^TåYçÛÂô,ënšk…&ˆwh+&\Û_ԢΎ~¿d ÜÏb̩Čªê©º›¾ÏÝô›fÇÕI|[ŸañÝô,~‡»éûÜM¡P3 Uþf3naz‡u7—¡3\Aù™m“ñ‹ðiÚ-â9¡tÿb,ví…Ðèá©þžÏÝôGÄ#?5B…fX|7=‹ßánú>wã7!èӺŽ6›¶0=‹>¬»AAÚ½K-S:sùE‘J䀯N&ý"›õ† ÍSwý¾ÏÝøÓÕ1¸£U“px“]|7=‹þîÆ÷¹™Èiƒ†«ú„G]˜‚ÅaÝMD‰,DzÛ»QêN®­aÄ J‰{¢˜•ŸÅ¥…ûQ«œân|Ÿ»ñgð·„ïkŸøÅ…é!XüwãûÜ?„ ®)4ÞY7Ÿô/LÁâ°î‚3ÒÝ‹äÙº«U#Ë쥛—l_,Ž0U"YTÉÕÀù>wã7!þ;~ɱö™nøÂô,~‡»ñ}îÆŸF(4¼FÆñÇlßMÁâ°îÆZ·&Ïöi°òcT–Ç—ÎÞ/:º;p´ÒR<ªïs7þ þŽÃÂXE é,ºy7=‹ßán|Ÿ»ñ‡i¥ôZ#·ñitónz‡u7¦•\j¤m™Qö~QœkÄåK›$õQQ¥„ú–Ñ`ÏõLù>wãO#”ãw5>jœ–“]|7=‹ßán|›»‰8ån¾P¦Ö½adèØ/®LÀ"ýï³¼ü"Yñ^<>qø¨tÿ"÷ðkâ=ÂÌLó#ß‹…ÐÀÌ/~‹÷óÞÛÅz§ò-v±MênV¦G`1>äW°x?ï½]¤§°M(ŽHsÜ…MvñÝô,ën ±B#Á÷°ÌuýÏýb™*G‚qnú~ÑJ,W-á”-s§q?ï½]|Šiàùã›6T²OvñÝô,~†»¹Ÿ÷Þ.Þ„ YdP±i<™ù¶2=‹ÃºíRµ°Fdˬ_ —Ø0L[ý¦ën"?h>Vµœ_Üæn¨è“>è5óõãn›•é!Xü ws?ï½]¼ ™Ÿ› …ûÐñýâÊô,ënÂ9QÑU0Y¿H˜†á¨Á5ÉêÀÅb°#vyÖLÿâý¼÷vñ!d"ìPŽ”8,'»ønz?ÃÝÜÏ{oŸF¨rq£Hª&+ÓC°8¬» ÏÔ˜íg|ëšÍüË£vQo¸Š _•æQá’kgÁUP†G½Ÿ÷Þ.úMqC„âÃö™ÊíÊô,~†»¹Ÿ÷Ö.Öò”íctTï1éñ..LÏÀbÖÝ`”†1¸C+y½›fÒ…]Œ¤r¶î&ãRŒPH—ÁbÝçnê]L£M"sp”$̸›…éX¬ßánê>wSŸáQ¨£AüÖÂéMvñÝô,ën´hx¥ðmÎji½1UÍ©”š‹Q£æGJ r݈ük÷¹›úˆØ„ûEŸf€¬N¢›…é!XüwS÷¹›úÿˆY|¤UeÍ•é!XÖݦa[¯p wƒæGvСLÜzºO#“÷³QXþk÷¹›zÓpä ŸTë<Öð_™‚Åïp7uŸ»©ÿ¡Âß‘ 6Ef»ønz‡u7¢a5¸!·Tmøþ¯y|Ñ€"f3q¶1cÖa•Ògz¦îç½·‹Ïð¨ÒªFˆ©X³]|7=‹ßánê>wSââ˜2¦ÒiêßMÁâ°îF¬a|d(^dd/¿XÂR´SdÇÔf»ønzù;Ü ïs7|ÓöNènÔ&™ÆÂô,ën0 C[CíM•œÆÆNX´‹FšÕ»‰Å5<\x Ö¹etÃïç½·‹!CÍã;v¯u¢þ¾2=‹ßánxŸ»áGÄFqŽÉ˜2QÖ\™‚ÅaÝMdÐb‚YQÈÚ’}ýÖª í õLZ’}¨(g¾†WˆõTÏïs7ü4B9à ʧeÍ•é!XüwÃûÜ ?„L¼n¥{+‘=LxÔ…é!XÖÝ1æYt&ˆl$uà¬G¦§\k„ç¬fý¢Skä˜è$©Y¨÷óÞÛÅ»˜¦8y1&QÜõ/LÁâw¸Þçnø&d¸a’5¤ÍNÔwÓC°8¬»¡ê˜åê•ÛZ1øo¾È¤ÚJøÆžö‹{57mÔ7”Yíâ>wÃ7!#|õëãúwv׿0=‹ßánxŸ»‘G€Ø"ÇëÖuƆ/LÏÀ¢ ënP7SººDž›¼ë×ßW«Xx7–ŒS½ü¢Å1`Æq ¸{ªNö¹¹ElH¼‰HÏúú¦g`Q¾ÃÝÈ>w#ô”DAÏ·˜öÆ“¬az‡u7TÑÂÎšŠ‘â¿è½:‰YD›…’ý‹p¥ÒððÂ-Ö”_”}îFbŠXøÊP©N¸…é!Xüw#ûÜ<"61=Ê\Ûd¶ÍÊô,ën¨Z‹ð/ ²äýbéŒÚneÅ@˜äýb cHx‹Ïô‹ûÜwc!ã²^Jã{R=µ0=‹ãº)âðžë™ºZó»ôQ¡ž­GíÚ*ú‰j²)ÝpÛçnì±¹/¬Dj:ãQ¦‡`ñ;Üís7ö2/Lg¸žp7 ÓC°8®»‰|1|¢zC~” B¯> 5˜*Eœ›ìÓߣʸ™ôœœís7ö2†i­WÏälZØÂô,~‡»±}î¦=Å4q Ç+Ã[3‰n¦g`±Mên*š-±EÆ—))ý©»ÁXbÂèuÌRÌÖݸTK„ö5u×ßö¹›v2?¦jdÄdu’õ/LÏÀbûwÓö¹›v2:0¨Ñ6»™Z˜‚ÅaÝMu6Fé ÎÊúŦñÖr,VQMöiÄbë¤Í»}=áê×.îs7퇴›Qd§Òi–i,LÁâw¸›¶ÏÝ´›i ¿q~ÛŒ _˜‚ÅaÝMœ-^gHj$Æ•/r/½·H“kä}©; ,n *Iš¯O_»¸ÏÝ´›1½¾r“:«*^˜‚Åïp7mŸ»i7!ƒa Š.…gó4¦‡`qXwS#k¸YtÅPÓ¤_C@וJkë¶§?~Q¬z‰gV*o øµ‹ûÜM{†GUì‰BÕ}v3µ0=‹ßánÚ>wÓú}õ‹\Í‘VM²þ…é!XÖÝTŠO-è˜Âœúäœ)ë¨)§ø3¼IÚ/vFkˆ©5ä),îs7íü-˜LgÈõÙÍÔÂô,~‡»iûÜM/OI”a¼Bé‘GL¢›…éXìú›Šá,ÝûUŒ–­»AîF½wF±@¶î³Œ™*±Ùúøï]ìûÜM¯,Xm„iXZgÜÍÂô ,öïp7}Ÿ»é7!S»*£¡èLYsaz‡u7‘æ]ƒi@ßHº1’ã¤ZD¸ëÑÂxÔ.ñÀȪ^Ây),îs7ý.¦1ÜUÔ¢-¶gRw³0=‹ßánú>wÓoBJRy¼hõIt³0=‹Ãº›Z‹,ã¤ô\b06U]É”µ¬â¿‰à_"dJñ¨}Ÿ»é!#µ?³NxÔ…é!XüwÓ÷¹›þwev´˜Nû¦‡`qXw¯†XÅ ‰ÌØ6˜u¼°f?Š–ìëï¥ú%{et}9ùk÷¹›~Ó~5öò“4‹QßMÁâw¸›¾ÏÝô§˜Ú¡¸4³Ù.¾›‚ÅaÝ š%\b¤G—ÒÅä ý¢q™µ°sÏÍ|»WÜ:ò2ãuó¯]ÜçnúSL£%œxÇ×õ™_|7=‹ßánú>wãw18F¨¢œ¦Ï&½/LÏÀ¢ënfŒ=U¨Pe°ˆ”Ͻ„{“@d¸Õl¾èð¦è”äœ)ßçnü.¦ 7‡¾‹€ÿ4ë_˜žEÿwãûÜß„Œ°5¯VUtv׿0=‹Ãº)FK"ãs3ÊúEeÔ¨]ÙUÖ/*„’ Ùf—T œïs7þ2¨Ûo—¦‡MT‹¦‡`ñ;Üïs7þˆØ\Ý3qJÆ >Ãâ»é!XœÔÝ\ã"ã;UMûÅFp*~M¹ÉúÅ=‹KÑÄ±È ÊâãÚð•é!Xr7VY«sÕZj¡l¾(Tœ®Ê™ÜƵóæD+´2÷‹÷óÞÛÅ›‰ÃFˆ zZʸªxez?ÃÝÜÏ{oå)Û¸7Òhyìâ»é!Xr7 ÒO¡ÔtÃ3~‘º{€¹×V-ÇÝü,.0IÕãÃ£â“Æ ©«Œ»mV¦‡`ñ;ÜMÝçnª<Î."&ÆÜÎÙ‰únz‡=Sñq[éMÕ#q”!Y^±[E÷ôÆá_½¯Ê­QJcã~Þ{»ø¯˜Æ¥Ð5wh2]zez¿ÃÝÔ}î¦þk„ŠH¬()‰NòÅ…é!XÖ݈AÝ´AQ„³~‘, ìWÚX2ø^ŒéjÒKÑšÃâ>wSoB¦ÅÏrî‘jÏüâ»é!XüwS÷¹›z2 n»] Ãì–xaz‡u7ÜLX!ra·ÞMÆ/Öª޵‘·b)îæZŒ ª žÉs÷‹uŸ»©w1…çoþªµÎüâ»é!XüwS÷¹z†GUMFäæ~¼‹ Ó3°Húê-âLkŒ,¬–¤_Ä$eü ½­¤_ÄÌÇâqz™rJïæ~Þ{»ø êµ…A±NxÔ…éX¤ïp7´ÏÝÐÓeëFÍ«ÔÉ-ñÂô,ënê…V£±“~±ˆŠæâDPì_Äbn‰ª´Þ2}÷óÞÛÅ»˜²<æ=B–γ]|7=‹ßánhŸ»!¹Óõ‚{ÃÞ}2é}ezÇ=SEÐ*Ñ0³­·ìýb<Ó®aßÊk*ô_ÄâŠÉ\ «÷¹º ™83z/ÙüD«xez¿ÃÝÐ>wC±y)¸†›Ì_™‚ÅaÝM8¶Ò+Zóµ[¦gªüŸ¢w‘Qˆ~«dÿⵘаË^ÖŠå¿vqŸ»¡gxnš Ç/‘NvñÝô,~‡»¡}î†nB†(bO¥8÷gmW¦‡`qÈݘ¹c®Ú'Ý÷‹_€X´…QMÎ%Æb%AénÿéÙÇâ>wCˆ FbR$óZ¦ÑÍ»é!XüwCûÜ —çê×1®S‡l’i,LÏÀ"¹L\3íÄͺ462~±A”EpµrFDŽïÅñ7kœ],ò>wÃ7!ƒKÔŠX'ý‹+Ó3°ÈßánxŸ»á›áæÐ Ž£-zã]|7=‹ã9S=¼¡L~2_T+µ°© †ù$õQ±ªã2¯U’íâ>wÃ7!Ó©s|ÑðÞ­L`ñ;Ü ïs7|Ó¨]Â¥‹ËÌ/¾›‚Å!wƒÁ­â‘±AçÔSwáÚ¤s¼·]¥¡\%é¥K¥‹2 ‡¼L6íâ>wÃz‡,áÑãÝ"˜tÛ,LÁâw¸Þçnø&dZÕ8"™ªv&»ønz'ÜWt>u«wŒšñ‹qæ@ÎMhÊúE w‡WG­YMñ¨¼ÏÝðCÈ„çÆl;C¢2ÙÅwÓC°øî†÷¹¾ ™êf­¡¡ˆ¦ùâ»é!XöL™·KeÙAâ'ý"(GÂèÐðŽ–ìëÅZ¤GÉYJõ~Þ{»øÓ8yœ6¢D³ûÅ…é!XüwÃûÜ<ÄDææH¨ê¤6|azeØ3Õ1Yb(GËöõkã«"ÕXPŸåQ#{wýh¸ÅTŒ*ûÜ<„L¤€LU!®<ñ‹ Ó3°(ßándŸ»‘‡a’ðxPçŸÝ/.LÁâ°gÊ=bj©˜kC¥%uà´÷ˆ/ÃM)fb¤°ø³¸—ÎZ<~zFî~Þ{»ÈOa[‘êÔ¼4Ÿð¨ ÓC°øîFö¹yˆ9^³î s{' ÜÂô,ÎæLieˆÞ©Ül›«¤´Cñ>¾nü™íÓ€þ·\kuc¨ñ¯]Üçnä.¦ánÜ{üD\þNvñÝô,~‡»‘}îFnBÚŸ$°õ>ó‹ï¦‡`qw#Ïð(k†AP˜Tl,LÁâw¸Ùçnä!dÂaP‹¬J¦7S ÓC°8¬»©P”ÆE¨ÑZ½ûO¾ˆòÛ¦¸®—ÑÂòE¿$Ñ<ÿTÏ”ìs7r2N*~»óŒ»Y˜‚Åïp7²ÏÝè#@\  ïl©3½›…éXÔaÝM%èè,P»·î®ÿ“/"Ós“®áG,©w‹TŒ^J9U÷¹½ .-ÁðâTfu7 Ó3°¨ßántŸ»Ñ§JcoHä*¼œìâ»é!X×ÝùEÎxXgmënzdÈ‘ZEÊé”Ââµêqî¯SRý‹ºÏÝè#@ÜÑÙUpi8ëÓX˜‚Åïp7ºÏÝèÓÕ #kj)ñÏÉ.¾›‚ÅqÏ5ÅDÚÍkK”wÿÔ£Bp\ÑfÔ*eyÔk–FsÌ'o=Õ¿¨ûÜ>"6‘É£.ª‹Ì*¦‡`ñ;Üîs7úÓD×Õ#j™Vø/LÁâ°î¦bªÅ‹§)c ‹áÚ£4z1t?j’GU oˆz3o‘³¦î4tŸ»Ñ›ùéófÈLýâ»é!Xüw£ûÜ>Äá3J‘oÌLµhaz‡u7S‰¨†'\ÛåÃ%u&²Òz²¯_ñ°«‹q‘œ_Üçnô&dZ•بûdŠæÊô,~‡»Ñ}îÆžbšŠañ5¨ŸïâÂô ,Ú°îæRâʦÀS6_T+ànī׵”Û_¿hñ¸0š¼Â¿f°hûÜ=„ ú³,¢á6ÕØX˜žEûwcûÜÝ„ dOYÐíMe†ÅwÓC°8¬»AÏS„Ôá ºÙ:kûë¹I8ªHú²õ¨Ê=\"þˆÿBŠGµ}îÆžÁß5>c¹n_fYÿÂô,~‡»±}îÆnB¦Wƒª»[ãÙœ©…é!XÖݸv¯ÔDÑ|™« êPö¥pŒR2Éæê]Ì,"ÂTÿ¢ís7ö ‚DV+ÏÌ/¾›‚Åïp7¶ÏÝØ#bù“—xSgÜÍÂô,ën.IÅ­{‹×/©§ýƸêv²}Tjœ\ˆ“ÚS¶ÏÝØ#@ E0#Ž´L`ñ;Üís7ÖŸ¦DŠeÍE³ªâ…é!XÖÝ4*‡Š™¤á¦’ºá‘çI©Í‹pçÜÆµ=»TK“xh),îs7ö2F×nWëódßMÁâw¸ÛçnÚ#bã 9`cÜWŒwqazÛ°îF[Å7@ª[â'ý¢2I‰“§öø+[wƒ¦kÖø±}ânÚ>wÓêS¶_(r»™VñÂô ,¶ïp7mŸ»iÏàïHáÃyp]šp7 ÓC°8¬»a7j]z#MûE+ñ¡Óž5§U|-¦ˆŽ­h—ÖSÚSmŸ»i!Øø¢-ÒÛßMÁâw¸›¶ÏÝ´§ŠZè™­Õ&1êÂô,Žën"N$ÖŽ[B«i¿ô†Ñ¯—õ‹ŠÁj˜IÏ+ÕKÜö¹›v‹Ø´%Öø–77ã]|7=‹ßánÚ>wÓnB†â]ãKœ¦X|7=‹Cî¦á>¡*J0ÛOçÒ¶&#Zó!nqIë£z-Ô+f¾)¥òŶÏÝ´öJ± Xµ®³¸…é!XüwÓö¹›v2ï›y«ÂNuaz‡Ü y¤F…0S ÕBI¿§Ž`²qW7­P,­P‘Z@Xf°¸ÏÝ´›²ø Ô¨N+6¦‡`ñ;ÜMÛçnúSLyεÉ-ñÂô ,ö!w#½GˆÚâ;ÄI"É9SPˆ¤*dí}Ò/ö+_l„êôµpÕïbßçnú]Lcøi]5,.LÏÀbÿwÓ÷¹›NÏÕ¯ƒ¾u¡™>êÂô,¹›&Ò¹˜{ø7ÊiC²Fð}+AÒqÝšÿWï&ÕæÒ bR©|±ïs7ý Fy©GÀ2Åâ»é!XüwÓ÷¹›~2ƒÙCãz¢ ¶0=‹CîÆÑƒX¹T"aKÝõ#å«,c¨¤ZÉöi`Öœ#cTÈÈ¥°¸ÏÝôgxTœ7P€´ÞÊ$_\˜‚Åïp7}Ÿ»é7!£¸>óHjHg ÓC°8 +:ªM¼­§Züj>Ä Î-}¿¨‘gz½p¼ò¯]Üçnú#@\¡Õk5¯“>…é!XüwÓ÷¹›þˆØÄ Çsžjø/LÁâ¸gŠ…ݘ Qš%\ÛOÝ÷Ž€.¼›¤çLÅO4‘r©!¬»µ~íâ>wÓoB¦B3#biÈfÎüâ»é!XüwÓ÷¹ÿ'@Œ¸H‡¬É¤6|az}Ü3%$ˆ‰6δÿÌÓ€žb!ˆÝ¥çi¸²Fjî뜜ïs7þ2-ŽÈ8:„•'ùâÂô ,úw¸ßçnüi„j,ðxñ/úäNcazÇ=S-ÿÒ0B‚%“òÝu7ZÄŠ#YÎæ‹è}lB¥ÕJ¹; ßçnœï |…xEà“èfaz¿ÃÝø>wãÏ𨆠°px½Íjই`q¬U|]‰r…l¸eJg~ú4:µæ^p—îë·.v]RÇ÷¹¿ ŒUhÚšJüs²‹ï¦‡`ñ;Üïs7þÿŠi\#¤Ú„G]˜‚ÅaÝMx$‡‡ºæGpR7\áÒ±5à cö~±UÆì¹þHq7¾ÏÝx{ ÛŒpaXTfYÿÂô,~‡»ñ}îÆÿ‰ØÄï´Dnc3¥”…é!X×ÝÔÖ{‹T70)kÕ™¿÷‹=P¨ˆÈQE—ž§Ñã§7«Æ’ô‹ûÜ?ãp›y<6‹nÞMÁâw¸ßæn"‹ú”\š:Š¨Û¸uezåŸååk-âÂ¥j‘¬F 6åˆP‚“ö‹®Â;¯‘ÿkïç½·‹ˆ Åqƒ¢6”'LvñÝô,Æû ïç½·‹7!ƒ< ½A¥ò¤6|ez‡u7T (¡˜ …¡Y}T4ÞŠ78éþÅQèK䪩Úðûyïí"?´š¹ Åw o<ÙÅwÓC°øîæ~Þ{»ø£xš!aÛm|3µ2=‹Ãº¢ˆÊ%IàF ù¨kÎ8XçJZ”É|1S4^äüâ6w#åßàïê5bBr<ÙÅwÓC°øîæ~Þ{»ø2U‘8P)m2‰aez‡u7ÄèÍ'ëUÌ+·Ì]ÿý¼÷vñ!dô’’Ь6þ9ÙÅwÓC°øî¦îs7Õn€5´uÈyúÌ/¾›‚ÅñŒð0ë•óiqM͇è8UµÞ¸ µÌPcþYÌñ£ÝÌ‹¥fÛÜÏ{oÿ!cqc|û¤gjez¿ÃÝÔ}î¦ÞÅ4¯ª”Òá=&ÜÍÂô,Žg„·R #I#çCá^Ê/â6$ìä*×õ¿w13´,.EÇu²ùk÷¹›ú2.èÓ„ü£Ì²þwÓC°øî¦îs7ô þô¼Æ^™'YÿÂô ,Ò°î&P@\©b2qËP¡ð‹µ`ÊwàQз ¿8y1F~±bÖwDóÞËW€ûºø¿w‘ö¹zŠiZdÆ])ï³]|7=‹ôî†ö¹zˆ¡AѮ0=‹Ãº›*åå•HR£…a t hÝb9g°ø³¸G4/ bÝSXÜçnˆŸÂ6gaí~ã]|7=‹ßánhŸ»¡GÄ&ŽGkhz-³¬az'3Â;š÷xñ<¥±×f-i×丬_4ã^Мԉ{ ‹ûÜ ÝP‘™–ؘŽ4e¶‹ï¦‡`ñ;Ü ís7tÓpôéA£¯ŽÕßW¦‡`q¢wãV¬Kä¸FÙº›H«ˆVVoLúÅXlÒá¢>|¹ø×.îs7ô¯ Âc•Âó¸qez¿ÃÝÐ>wCˆMkV82ÂX³ñ.¾›‚űÞMe*²Fa.ɹĕ N6Çí’8ÍøÅXŒ2ëdó×.îs7äÅíáƒ#ìñ™_|7=‹ßánhŸ»á›‰Ä;´]fùâÂô ,ò°î¦–nl¸²/-Бô‹$Š£X*×]Æ/Æb /T![^–îï"ïs7üˆØD Ȋɯïâ»éXäïp7¼ÏÝðCÈH ªCÃÓ&~qazÇz7…"BÅA‚*ëÃ-FŒÉñíš~ùëãqÅÁ¤e ‹ûÜ ?„Œ4j ·NvñÝô,~‡»á}áQ.ÁÐÂ×M`q<#\JV:¦¡öÔŒp¸6LˆÂPm¿Ü”_ôŠöyb<´e€ûk÷¹~cÄI¯éø º0=‹ßánxŸ»á›©ÅZüü(ͰønzÇ3Â]«… Ž6öžÓ GhF%œ5Z^þñ‹±ä-(KÎq7¼ÏÝð]Lã—Žk_¬³]|7=‹ßánxŸ»á§˜† èΛs™ŽvñÝô,ënºy-:Gw‰¦fÛ@è8ü!¼HD™ÒS1êÏbµxZ‘œÕ–º_ä}î†ÿ5BQÄTã—>ËúßMÁâw¸Þçnä)¦qês7™§±2=‹2¬»é˜2ع¸‘Fê—ô‹ÇY¸ÆˆÊ‰Û2åûã¢Ãä‘eS»nS¶±(ûÜÔGr•³Œue’õ/LÏÀ¢|‡»‘}îF›&5"hn¢æ·2=‹Ãº›pàÕ%E.‘ø%çW¨)šQ$Ê\%ë±Ö{ÃìG§% ûk÷¹y÷ësÆïÍ&~qaz¿ÃÝÈ>w#7!ÓÅËÕYŠNáÉ.¾›‚Åñœ)1L†c#½tàR~‘Ü`E4ð3#<åÃ'B NšÄâ>w#Ïào«†Ä¶öðy“]|7=‹ßándŸ»‘gxThª+µÁØdßMÁâ¸îÓL!š…p±$¤¿übkÀrG{¿¥bÔŸÅhæ¶áTíâ>w#7!Ã(>jiì}¢w³0=‹ßándŸ»‘›!-T#™G1ó‹ï¦‡`q\wST¸9EÒ¦µ¥îúáÚ"( fgýâ¥îÁªèÛMÝiÈ>w#~SÜ& ©<Õðx“]|7=‹ßándŸ»Ñò¶EV1:Š&SQV¦g`QÇu75’ÜRѾiX¶îF Ó'”¬—ªËòî?~¥»èéÔà¥jÃuŸ»Ñÿ7øÛpƒß›ÌNÔ…éXÔïp7ºÏÝ(=ÂÜ ØF™ð¨ ÓC°8®» ,B++âSni¿hTzé¸äÞR=S×âZÝb«ä°¸ÏÝè#bÓ¤J0Pe4ÙÅwÓC°øîF÷¹½ 'eŠß6¯³^â…é!XëÝ«®« oC©¸øÆV _%$©»þŸÅÚŠ  î§[k‹ûÜÞÅ4Åè£S£IÖ¿0=‹ßántŸ»Ñ§˜†âU!ÆðÜYÝÍÂô,ŽõnÊÅh…'@Θö‹¥1‰„[õ9³~1SQÄÖ’ë_Ô}îFŸbš‚KüÎqÀDïfaz¿ÃÝè>w£!S!n-Í©ÌÔü¦‡`qXwƒ¹2-’6nÖXçîM-O­¸õ¶¼®ÿë#cPÜM”)îF÷¹}¡"Ÿޝñ ‹ï¦‡`ñ;Üîs7öÓTk¨ŸŽ,P& ÜÂô ,Ú°îÆ]Q|Ù)’·â©8¸6C¹˜TLœl©ž©k1×x\,RËzñï¢ís7v2 —¤tgŒ_ìâ»éX´ïp7¶ÏÝØ]LS0$4vˆªÓ$ë_˜‚űÞM${^‰¸Iï59—¸ZøÔˆn­Z„tÙûEs|¢VMS~Ñö¹» ™ŠÚ"°£Å}Ý,LÁâw¸Ûçnìi„"&D`µûlþâÂô,ŽõnJs‡BjÁÀ©l_¿I³@p¬®š‹QcZœ*:ERù¢ís7ö4B ¦¶FzÿcÂÝ,LÁâw¸Ûçnì&dÀ‹,PªÌvñÝô,Nôn ‡9á@TV O„ž+ÃË›õ‹ªRz§5Å£Ú>wc7!‘SãÑÓYŒúnz¿ÃÝØ>wc7!#ÝP¥ˆ=¹%^˜‚Å‰Þ …Ç@S.-§á×(,-º9eëQcq‡’…£d0ƒÅ}îÆB†#©…¶²0Ͱønz¿ÃÝØ>wÓoŽ1`Å|v¢.LÏÀb›ÔÝć çÔ |–‘þþñ‹• õHø‹é> ƒ¢³¸ÔgÇ6Û>wÓžb×ú¥”5ÓØX˜žÅöî¦ís7í…ºé¿Ð´Ocazgu7µÔ µª’ª ¿\›(š® ­JY½›XÜzëvMTMõõ·}î¦Ý„ŒBȵ“tÅ|¹ñ.¾›‚Åïp7mŸ»iÏð(Ç ¾îøç„G]˜‚ÅqÝ .´¡?ÕÑÙ›œ3ÇFa˜vÄåYÝp\h¢öZÇœó‹ûÜM» Ç5f!é;Éú¦‡`ñ;ÜMÛçnÚCÈu”ˆ… ˜©Ü.LÁâ¸î¦–bQf8uÊŒŠºüb‹À6²Ì êë0ó_ŒÅ Ʊq®¯¿ís7í îL‘$=&»ønz¿ÃÝ´}î¦=Å4®@ƒ¸WhPŒwñÝô,ŽçL•FÔš:(üìüEÔ‹¡ê/BMë5{¿‹’$ñÎ7Jñ¨mŸ»iˆ ¡Ú Tf»ønz¿ÃÝ´}§Í»c@FFB“uazû°îS[ãÖڭgçLõkh›ãbœ4›/ÆÑUÙéê¡Ïé£ö}î¦×û˜dC{)”OmÂÀ-LÏÀbÿwÓ÷¹›~2W3Z{LË„»Y˜‚ÅIÝ ´¿5àè˜ášô‹jé`b…²õ¨ fÐø€GNÕÝô}î¦ß„LV¯.ÜáÀÇ»ønz¿ÃÝô}î¦ËS†¡áí ×ÙÍ…é!X×ÝÔo^$Œ¦&¹Ù60Ù"Þ\ï€JúÅk$ˆ.èA¦bÔ¾ÏÝô[Ä­lµ*’gÝ6 ÓC°øî¦ïs7ý$GØ"f3¸…é!XœÍ™’ðPHü•©™oåÿ¨ÄɃAáÕ¨{ržF,ŽŸ(uî!U¿vqŸ»éÏàï_ðÒÓi¦ñnz¿ÃÝô}î¦÷›ân ¦RÍÔߦ‡`q\w.±@ñü’çMÎ_ br¨GºhœíÓÀb3F³·–šmÓ÷¹›þ2âŠc£ Ažìâ»é!XüwÓ÷¹/99#‚+“¬az}\w#ÆÚ}„á¢RÜM¸¶kè[3.˜•̱m-—Bk®gÊ÷¹ÿ'bC~\g=S Ó3°èßán|Ÿ»ñ›‘"ňkíÓ E ÓC°8®»1”î¡­zR“®¡áiÁµš¼_ÄbCÁY/¥­Eä~íâ>wã7!ÇdÇ´Wrö‰_\˜‚Åïp7¾Ïݸ<øê(·„$ø„[˜‚ÅqÝMc·pPU¡ šÔG¥ÒÅÂßñÜÌ·k±2CÔŒ)Õ3åûÜ?ƒ¿"w´ Ï*¦‡`ñ;Üïs7þCÈ8dǤ D„ëä–xazÇu7½: ‰Zë?ʈ¿ˆaASjñö&ý"æb–[ª¼.øµ‹ûÜß„L§Ö©¨ÊôD}7=‹ßán|Ÿ»ñgx”`â„W´ÐLxÔ…é!X×Ý8áBMjaÈmdý"5twŠ@5Û×ÅŽz8»Â=¦°¸ÏÝøÓ¥˜-WY1Ôj²‹ï¦‡`ñ;Üos7ZB¦E¬¹øLuezõŸe½oó?ÈUršŒpmÝ*ÿP¯Ù|±DX a£­ Ëÿkïç½·‹7!G¤ˆ4BÁÝøNcezãC~‹÷óÞÛÅgðw‹4^´Wg+ÓC°8¬»¡bWÎjxƤ>*•†Ž'”àR]·=ýõ‹Í·ÂŒ™;ûyïíâSL£DŒ-”6LvñÝô,~†»¹Ÿ÷Þ.>Å4=NÿÞ¶cnez‡u7PȨ"2ÅE³~±*"[»¾øZ>ê/?’¥4Ì iîæ~Þ{»øˆØ dÓí¨Ln¦V¦‡`ñ3ÜÍý¼÷vñßð¨ˆ<Š.y2‰aez‡u7ªç*šÅ=«wp¢ø¦Ö¡TlÉyXÜâo¿nds1ê6wÿ˜UoÕ»JÔ£®LÁâg¸›ûyïíâMÈ\³¿8Ò@•‰ÆÆÊô,ënŽFA;WËÕ†ë¶*T Ñ\²~1²Ì¢PXE›FÎ/ns7ZnB†k|QÑGÇä®ez?ÃÝÜÏ{kk¹I¨øÂiÐ4F]˜žÅ:¬» @`@v %ÙºbÁ±SÀÿK ‹?‹{︋ 3X¬ûÜM½ m"xlñxßMÏÀbýwS÷¹›ú þˆÖ:tˆ'*·+ÓC°8¬» â‚Q»¡¨4›/SsLn,µô¤>j,ç|ÝâQÏÌB½Ÿ÷Þ.>Å4‹ÕV¯K”É.¾›‚Åïp7uŸ»©ÿˆÑÔÃB>SgX™‚ÅqÝÿÔ½Tœ$i ‡ ~$ól¾ˆÍ—\k™¸ûyïíâMȘx'¨S´o‰W¦‡`ñ;ÜMÝçnêÓ¯JdòÞ£¾›‚ÅIÝ0F›wЍ,Ë£z­Œ¹odçc1¦Û0ÊïÖŬ¿vqŸ»©O1MG ÆU!Tf~ñÝô,~‡»©ûÜM}™Þ#cᦸ•é!X×Ý@ñR2’ú¨Ã™µÞ){¿‹µ9âA·T Üý¼÷vñi„B[Îù³]|7=‹ßánê>wCw1¨a&±µÉÌ·•éX¤aÝMm¨¹!w…”[ºOÃ5 t{$ç HÝ~Zw3÷óÞÛÅ[ĦŠD¸r}Oæ¯LÏÀ"}‡»¡}î†þ_#TçÚÕP>9ÙÅwÓC°8Ö»X j´5_JBjá¥Z§l_,.™Ð·›Ââ>wC7!cÙ…ˆ0,r²‹ï¦‡`ñ;Ü ís7ôÓ4±ïªj£qŸÆÊô,ŽënJW»¹´‚öþ,Úýp/¯p–Gm-âî‚Ê›Ô]?ís7ôÓhé?-~žN²þ…é!XüwCûÜ Ý„Œ³s7tÒô>Ãâ»é!X×ÝŸ* yÄ´_„þ$+®T{OÕ†_‹µ([ä«‘9¦îiŸ»¡GĦVî‘ŸŠˆNxÔ…é!XüwCûÜ =„ ƶ´ªL}Vá¿0=‹ãº›ÂÍ+J/kÓžân®”O"*ÌÊêFÛÿ䋸 1̯ðJûÜ Ý„LD,ñ +f(O&÷­LÁâw¸Úçnø&dÌâ­qÔ§ÈŒ[˜žEÖݬ蜅UJ“W„Bw©Œ»þl¾X¡g‘®Vn¹•÷¹~m¯Vâð˜T/LÏÀ"‡»á}áQÍ¡ S¼Oª§¦‡`q¬wãл‘T“ºátÉ¿qÿ‹‘­»©X…ê;Œ‹NÝõó>wÃü4%BÒÃÂÝÕ6¹_\˜‚Åïp7¼ÏÝð]LƒáÙŒžÄæ“)š+ÓC°8©»‘Ƽp­Ås³mò]5á]©iú~±ªz3í-2ÆT ïs7¬Ï¥¡b²ôRiÂÝ,LÁâw¸ÞçnØá %ý4#Ÿïâ»é!X×Ý8uêáÚº÷´_„æÐèä\âX,¥u”›uÒwÃûÜ ?Å4Y(+çYŸÆÂô,~‡»á}î†ÿ wÃÌo°uaz‡u7`B[gh¤†7ÏúÅêjbJ}bÉù‹X¹5d,Ù†ñ.¾›‚űÞMUC±–€Uvþ": ÓÞ £Ñ³÷‹I¾®3dl ‹ûÜüü-ÞH. ‚Ù‰únz¿ÃÝÈ>w#ÿ™ðrñÂÅI9=QßMÁâ¤î¦ƒ]ŽÓw¢É9S—þ£¿³™Òz7•>˜‡l’ËeŸ»‘G€8¼'jŠ™“]|7=‹ßándŸ»‘‡‰©ŠRñÖNvñÝô,ŽçLyaÅð5ÃZZïÆp‹£÷Ùóý?~±c ôŽ›§tàdŸ»‘›ÑØ/Ô1ânæßMÁâw¸Ùçnä.¦i˜ŠVZiJ›ìâ»é!XÏ™RÈkPd}ÈÒs¦Ðö(îáS×åÝý"£U°cR8­‘íâ>w#þ„,á÷ z¼|Vɸ0=‹ßándŸ»Ñ§Ê0àÔºF06©d\˜žE×Ý Jˆ{x'º®Ó²÷‹qöƈ´1­wS…\+[eÊé£ê>w£q8oÝ‘ËìD]˜žEýw£ûÜþ±‰½‡à)fÚOvñÝô,ënzóÚ"W¬¥ðÔä ý"WiRñÃAfïc1ÂŒ ·µˆÜ¯]Üçnô&d8œ©¸:Ÿ©3,LÁâw¸Ýçnô&dpÝ„”ÆŒl¶‹ï¦‡`qXw8ªÂÜj÷&–Â"\[d‹µ‚sdéi¿è(ÛUÂXuKñ¨ºÏÝè3ø›­Sƒî6‰Q¦‡`ñ;Üîs7jÏÖ°TLé2ëÓX˜‚ÅaÝ I~›Êœõ‹Â.¨ÝÄ0˜4‹Í´D€ ¹§÷¹½ G_Vc†8ؤOcaz¿ÃÝè>w£7!£ÆÚ¹xSmÂÀ-LÁâ°î†¹B½»ª RD˜) ¿(PKƒ©‘ZeçLICc„,-¢Â÷¹}¡ÐŸµ³Nf¾­LÁâw¸Ýçn¬wc7!à …st>OØð…é!XüwcûÜ="6‘ÌX)¸ž©¿/LÁ☻Q 42¤$«ÔTŒ®­Y@©_Qn_—±ýñ‹ ÃæŠi'.53#ü~Þ{»èÏ1 I0+qtø,ºy7=‹ßánlŸ»iÏàï=ÅÔNž°á Ó3°Ø†=SŠLÑÑÁHUZÖ/«°Æ÷.”›ùö³8ÒjG@h5Å£¶}î¦Ý„ Z,¥yEMÍ„»Y˜žÅöî¦ís7í!sõëWtëϰønz‡=Sæ•J1qÌ©»462~R9¦Íºˆ¤uàbq¤šWw’¬‘íâ>wÓBêä¯t‡æÜxßMÁâw¸›¶ÏÝ´‡q—þÉôD}7=‹Ãž©Žª„™ žZ–GuëÃ' ®š« ÿYŒ1á¸Õ’š§Ñö¹›öᆎE«ædßMÁâw¸›¶ÏÝ´gxT-IQÌfŠÓ ÓC°8ì™ê­kEŽÛÍ!˜•ó‹îÐþ®PÀcÎêÀÅâŽb3 (Ï飶}î¦="6Œ7¾†Õúä–xaz¿ÃÝ´}î¦Ý„Lœßªâqô»Ìüâ»é!XöLyáø¬ iÑÒr~ñº“@ÝfùÖäüE,¶x^ ÓTsó4Ú>wÓ›ÞJ8bªµÌjæ‡`ñ;ÜMÛçnúMÈT²Ç¡ñ¾Nn‰¦g`±ën³9©b ‹RŠ»ùÏÿq…L“\Ý)žÕ»aH׈Q URõ¨}Ÿ»éO#EØp™9Í4¦g`±‡»éûÜMˆ‘M‘“U0ïã]|7=‹ãž)W‚XW(õ”¤_¬‘bŠ{¹är²~1SgêiLË÷×.îs7ý±A‰iW¹”y&»ønz¿ÃÝô}î¦?ƒ¿12ST­Î¦¢,LÁâ°î¦KC¾©¡b(éq¢(à —›ùö³¸7ˆYp<­Ú÷¹›þ rˆ2 Äufj~ ÓC°øî¦ïs7ý&dÂk©Jõ“]|7=‹ÃºT_²rD© <~Ò/2fNDV¥áâ²}Xl;¦}ꮿïs7ý&dâSF<]½bêãdßMÁâw¸›¾ÏÝô›1ꇤÀyÌvñÝô,ënL ã¡ïIý¬_D£f„§(Ÿ«É> ,†&«†j=u×ß÷¹›~2]¹ujV*ó,F}7=‹ßánú>wã7!9|/ÞÀÞɤOcaz}\wç?Š»uó=Ë£’)"œ‹Œ1ëc±`¨5\Éf°èûÜß„ ªK­4pL³I Ó3°èßán|Ÿ»ñ‡)­°£÷u£.LÁâ°î†µ a.e|fÉêÝ0tø{í=ÒMµ¥kûŸ|Ñ#lÈ˺¦xTßçnœïô½ÄYqg±Ù‰únz¿ÃÝø>wã7!#€µHS2&»ønz‡u7W|Þ5y­×Å”_ì :"˜“ÞJ ‹?‹½V‰à=§áïûÜß„ŒC×§6m>©d\˜‚Åïp7¾ÏÝøSLÓÑç‘56«d\˜‚űVq‰H,à„{˜"àQ-á*nᦳ¾³wã7!Ã>¦X«*3¿ønz‡ÜM$‹‘~fvOêÀ1E–X©„ëË0ó¯_„–cçv‰ ¦ên|Ÿ»ñGĦ\“¿A5McÔwÓC°øîÆ·¹+± ³ÄÛjm2#|ezíŸ%v‘ã½kÊHTiÉzT†ˆ?”§ì§3%›/†ûñÆ­4OÍÓ¸Ÿ÷Þ.Ö‡-¥TüÕ>ÛÅwÓ#°ò+X¼Ÿ÷Þ.Ò#(…ûð&á5&µá+ÓC°8änDâ…#¨ºjë”ꙂkCEÂç½–¤ÞM,î p­uËhßÏ{ooB¦peŠ3ÒšžÇ»ønz?ÃÝÜÏ{oŸF(­0޾ÙDåvez‡ÜM|bÑêÂ)[wÃÒ‘Á¤©¬_Œ˜¸†G·¶ÔÆý¼÷vñ!Ñ— :J&•Œ+ÓC°øîæ~Þ{»hpF8º8)«Æy9ÙÅwÓC°8än ¯Ô5Ú²õI¿(ÅÑMˆÌÖ†ÿ,vp©á\«gî4îç½·‹!Ã…"/$0RãÉ.¾›‚ÅÏp7÷óÞÛÅG€¸ ÅÛ´L•RV¦‡`qØ3eçš5PwS“}ýL]%¾2G0çkúåênTµc¢q×?…ÅmîÆÊ-b#ª‘_ÓÈi|§±2=‹Ÿánîç½µ‹õ!Ãñ[‰ ¹Œwqazë°gÊ,ÐÈNLárwý()ÕR#áSÃXlŸF,ÆüÕk jJî~Þ{»x2Š:ŽÁlÅÉ.¾›žÅúî¦îs7õßð(êàG»ôIçÛÊô,{¦Ð·ymаKÝõõy¬Bv…éé> ‡/îãP{Ê/Ö}î¦þk„bŒ} ¬“^â•é!XüwS÷¹›z2­®œÂmTañÝô,{¦0XØ)²>ŽŒ±eën*÷Æ5ژײŠû¹·ð©L„ª³÷¹›zªI±Ôðà­Lî4¦‡`ñ;ÜMÝçnêÓÙ¨ñÎæ/®LÁâ¸gÊ"N„‹{'Ïò¨Õ “¾«F¨¹¦BÿöõGdzµË©;ºÏÝÔ›‰³—ˆ†{ï:án¦‡`ñ;ÜMÝçnêSL# n¡3,¾›‚ÅaÝ ¸_ëRˆá 5ëÉܤ[wm={¿ˆW\Z,´n™¾þûyïíâ]LÇN%\jNú4V¦‡`ñ;ÜMÝçn¨<…m{£LVÇ}+Ó3°Hú§PU,ÀlÝÍÕ…F=ieM¿üñ‹×åD!*,”ÒØ¸Ÿ÷Þ.Öûº©¨’9}Ÿp7 Ó3°HßánhŸ»!zÒ‡"¸©ð‚±ñ.¾›‚ÅaÝM(¨†‹*áÓõ¨E"O ¿`üYœÒ“ÉÔdMüüÚÅ}î†B¦TŽØs⦇`ñ;Ü ís7ôˆØÄ±-U@qL±ønz‡u7 bÞM!ei}Ôp«I)qeõQ›+®B¼£È%…Å}î†þÓ”R!^PlRá¿2=‹ßánhŸ»¡›”ì÷köDïfez‡u7M Œ¨¢Ì¨Êê†KÑ#Äîe=Zø÷.bqcÜn^E ‹ûÜ Ý„Œ 3¾b/ñ'»ønz¿ÃÝÐ>wCý)Ûïqê_ÍÞ3naz‡u7ERí¼©ž­G%g.Pij¥RîNãg1£7)œªÔ÷¹z¡úõËDµhez¿ÃÝÐ>wÃ7!c{/ê!žÜL-LÏÀ"ënœ)7·Šûþäýb|Yih^,1·ìœ)ô³ÄQ d­¤°ÈûÜ ?ãŠu"‹Ðt¶‹ï¦g`‘¿ÃÝð>wÃ7!ƒ>¨‚ȳȬzjaz‡u7Ú:‰/ú¦jêN£…5ÒMøÄîlÉzT,î§#¤(Ó×?ï½]|Dl@©µ8tºN&½¯LÁâw¸Þçnø±vFéjó>…é!XÖÝ ýYšÇÙQwÃq…Œ€^Ê<“ê©…é!XüwÃûÜ ÛM«iÀK"—wk“ ÿ…é!XÖݰˆ$J!ÃX´_ÄmFsb÷šŠQ¯Å­¢ý1Ö¥ênxŸ»áv_¢ãt¼Lýâ»é!XüwÃûÜ ßÅ4 U”Aó$ë_˜‚űÞM³†úð-9 5\[qªñ—øGÖ/*j`UlvÎèÝÜÏ{ooBFûE÷2…3ž°á ÓC°øî†÷¹)³cÂUxÕ>« _˜žEÖÝ@š—Â7ÕŠKnT¿HÂ/ê5}±ÄÚ¹á?~QñÖÇÃc©¸J`Qö¹yDl<Ž ¨‚±Ìn¦¦g`Q¾ÃÝÈ>w#O#CŒ<ª¾0=‹Cî&PTÙ{D׌‚è¬_T® ºÄ<Ù§AjPÄT'Ì’IaqŸ»‘»˜†ÁÛ±õÖ¤L¸…é!Xüw#ûÜÜ„ w³§~d)}v¢¾›‚Å!wÃh\Š|¯D|--›/FT‹ÕÍHÑI¿‹=R²‚;õ–ê%–}îFôiça1eÌNÔwÓC°øîFö¹¹‹i"f!Á¾´Âîfaz‡ÜÍ5Ç” áÍ•z–Gej˜£î-×Kü³Ø @]rXÜçnäßàï8mjÇ„ŸañÝô,~‡»‘}îFúsÝdEX/)éÙ.¾›‚Å!w9Å¢l-’F©É¹ÄáN!q\+tÃkÖ/ò5¯¡@âGQ`‹ûÜ<ƒ¿÷%¢_&õ¨ ÓC°øîFö¹}”hE He¦8½2=‹:—¹ªGXÍ’ö‹EãÕm¦Ü,ÔŸÅ‘¨¶Î¨¤KÝõë>w£õiÆð͉±Ì°¸0=‹úîF÷¹½ ™Á¸Å»†A “^â…é!X÷LYë(b2i)î&\!Q<€Z,ëcqdÖÒ"ý뚺ë×}îFBF#¥5M¥N¸›…é!Xüw£ûÜ>P ùÎþ2ë%^˜‚Åñœ©ï^¸ˆÞ‹^®m²=C¿X)üé5ÑG’=S?‹5ܲÅ/½¥î4tŸ»Ñ§˜&|1zžu¦¾0=‹ßántŸ»ÑÄ 6-z“éÒ+ÓC°8ž3…¢Œ4 PéÕö´ÅpmU"YÔ¯-YËÞ/ÆbfQøÇÙ•Ââ>w£q‰ˆJ‹Þn²‹ï¦‡`ñ;Üîs7z2‘Ú5ÆMËdZØÊô,{¦* g¸Fxˆ¼îú3~¹aºøFÊ÷Ç/âddÁ¨C(Á¥°¸ÏÝè3ø»VŠÛÃÏ&-LÁâw¸Ýçnìn„Ь¢à2ŽËÙ„¢…éX´aÏT ß%Éf•È’~±:Êá·"^[2_Äb)äÅåœÊmŸ»±GÄÕ 3²ÁI¦±0=‹öîÆö¹» ÅàÝH¦pXN2…é!X×Ý(+Æ5C‚ꧤ4á!ÉØÄ ÑÌžõ‹X Äݦ[n¶ís7v2«‹_É☨驪`ñ;Üís7ö4B]â{µZfùâÂô,ënjDcª W Y¿(™"©õª%©wƒÅ­žƒÂSXÜçnì&d,~„7Œn:©ØX˜‚Åïp7¶ÏÝØMÈ8´•XÃm˜Nî4¦‡`qXwS1<±”†[˜Ÿ»þŒ_Dk‘“F€ ò'é;†„׈çÑPœÃâ>wc±° Ýç³P¦‡`ñ;Üís7ÖŸv6k3J2ÝÅwÓC°8ë™BÕL)]÷’Ââ®oÌ­`h(Õu â¿‹µ•ÒÊá’SXÜçnì)¦‘êqèHœÍòÅwÓC°øîÆö¹›öˆØ¨’ÌÿF»ìp¦g`±{¦:†L54?•fÉûÅŠS@V9’¬¤_Dø€™Æ5rUMÝi´}î¦=ãÂo—ø”P>d Ó3°Ø¾ÃÝ´}î¦Ñ}Ljä£w§u7 ÓC°8¬» §ˆlM#º6Iûņé²Bê(1OÎ%Æb‚v•Wiëá¿vqŸ»i!SpJZ4ÜødßMÁâw¸›¶ÏÝ´‡q½jö›´Y…ÿÂô,ënZŒµwïЭI¿hÚ!ŒÊ ÃÔÆÏb†àU§R=¥áßö¹›v2„V±+87&1êÂô,~‡»iûÜM{ˆ[ oÇæF3}Ô…é!XÖÝ`ª°t—®-ë5–âjœzDY5ãgvWÂ@§ ÷¹›v2‘t‰(ô&u7 ÓC°øî¦ís7í±áÆh†ê\ÚÌ/¾›‚ÅaÝ U ¶j…ZòN#¾1„«øŒƒ›œ¤_ŒÅ‘i^ijÕ¥Sýµ‹ûÜM» éêûˆ§Åf~ñÝô,~‡»iûÜMGFûÁçä®azû°î†˜jñjdNéI¿È˜fÌš£QR‹¯á¿ÐãÔ<¾ÏÝôGĦ y„áµÈlžÆÂô ,öïp7}Ÿ»éô”a”À˜‚ñŸ)ˆ-LÁâ°î†´]’ÎZ¥gïN—|œáÖ>{¿‹…Ì ii©|±ïs7ýÕµi+—àU™ìâ»é!XüwÓ÷¹›~2ñ¢¨6Â4ë™nøÂô,ënJ­U*ŠL)ë Ò=Ì0.KJÿúÅRã‡LŒãžÒðïûÜM¿ ™Ð* „ÏØð…é!XüwÓ÷¹›~2¸nêÉB“Ù.¾›‚ÅaÝ ™V¸¥ù™–½_$ÅÀîÞ‹‡¯ÊúEÂÏ-ñ¸èTÝMßçnú?4—ŠãßL²þ…é!XüwÓ÷¹›~2Æ‘J¸» ·0=‹ÃºÒK GÆÈÈæ‹ñâ"ÙkÌñ“ý‹ÝI?Ýý¹9S}Ÿ»éÏð(—pûå·6©žZ˜‚Åïp7}Ÿ»ñgð7+nÂ Š¾“]\˜žEÖÝ„s*‘uøNÙ¾~Ìî…;z¦š§jà~GlÙuü3£ú>wã7!ãªqd´ŽîåÉ]ÿÂô ,úw¸ßçnü&dbS*d<)^ØÙ.¾›‚ÅaÝ ‰[i½·pçHr“~‘¸]ÁyËÝõÿ,öê¦ê^ WýÚÅ}îÆŸáQ ¡Y²ObÔ…é!XüwãûÜß„Œ3~‹©5}vK¼0=‹ãºÖøØñRéíR€ÊøÅb…‘yÕ¶–úã#Õ,‘Y³k‘œœïs7þ¯˜¦ÆgUõVyÂÀ-LÁâw¸ßçnüE‘Ó`úTÍoazÇu7ß«^Íì’ŠQÿóŽEñ­•Jü•pªü³8~0ŠwZ[2¸¿vqŸ»ñ›ÁœH—8w0…y²‹ï¦‡`ñ;Üïs7~2×e“rßñÆNvñÝô,Nên´b¢ŠHÏŨåÿ\Èë 2dDå ,b1W wl‚f%kôk÷¹ŠiŒQx„~–i¼›‚Åïp7¾ÍÝ´r2TSj¸<Œ'îâÊô,¶ÿ}–?õ¨,­ 7jI¿ß“8€ˆ¨f‘ùgq$›¢(€C±Åûyïíb}&\D:㛩•éXŒù,ÞÏ{oo6WˆºÍ2Ö[™‚űÞMø6 _d+µSÒ/6‰x®×V¹qÎ/64Z™±F +k¥_»¸ÍÝ´rÓ€¢2Äâ,Ó]|7=‹Ÿánîç½·‹O#”ŠÇo ¨÷qt³2=‹c½/T¡º÷®Iµ±ÔK!Cú¥ð“ò‹ w’×4n¯¦Ën­_»¸Í݄þ ìŒ×ª¨šìâ»é!Xü ws?ï½]|ˆãmm¦‘ÚDccezÇz7MQ)Ù^|ölŸ†9g —j‘ÃYÎ/ÆâÖ!{X$‰¥Sýµ‹ÛÜM+7!ãlP#r qŸÅ¨ï¦‡`ñ3ÜÍý¼÷vñÕ¡© O&½¯LÁâXïF¡±/žIMÀ ~Ñy„t§)±¾s„·^˜Ðì±$~~íâ6wînJ _ÇU"ƒà‰šßÊô,~†»¹Ÿ÷Ö.Ö›‰÷D#™r”íObÔ…éX¬Ãº›Š¹mV‹Këæ),†kC„£L©­©Ð?~‘0 YRùÔ—¬ÑïbÝçnê?â8&I+¦øLüâÂô ,Öïp7uŸ»©7!SqÝ¥8†vNvñÝô,ënÜ£½„ë 'ça@¸Fs— Ë?‹¥1®3ºH]&›¿vqŸ»©ˆMÄ+Ýjw듸•é!XüwS÷¹›ú þF0æ©Äù=‰Q¦‡`qXwÓâÔpè\Ô8©ró­’”´ÿHq7×b¥«,ÜÃåüâ>wSoB¦"ò4 ´’ÉDÛ•é!XüwS÷¹›úˆØ¸3†¢2÷¯LÁâ°îF(’#.Ô-ÉùÅp§’¾F¥ÇSÈùEøbu“ðB,ë ‘_»¸ÏÝÔG€˜( oƸğìâ»é!XüwS÷¹›ú Š—µA ¼Mo‰¦‡`qwCq¼mÕãué:QJY™žEr7˜Mn€+ã†T¨$ü¢+‹FŠÌ5‡E,æ¢Ýpå^9Å£Ò>wCÏào Òjûµ»ñ.¾›žEúwCûÜ Ý„L‡]} ³¸…é!X÷LYSïÅ›YuNæ‹zÕi_U;æë+Â?~1ܪ"Ô+õ5ƒûk÷¹â§à»4çŸv²‹ï¦‡`ñ;Ü ís7$7­ÖT¡“ÖÜiR±±0=‹CîF,ã]|7=‹ßánhŸ»¡‡©ªè)*­·ÉÍÔÂô,¹”À•rIž5Îq7ÿù?ÍX‚nM²î&s»†cÔHÏrXÜçnÈáŒHù‘áNTnW¦‡`ñ;Ü ís7üˆØDîP"‹Ðˆ='X\˜žEöLuê];úˆrƤ_”f˜f«‰3BÇü³8@å.Ô"°OÝõó>wÃ!íDnG‡MØð…éXäïp7¼ÏÝðMÈ×xO…0ŽiR¾0=‹Ãž©.^´Á XC{Î/Æ´3tG3|Š»¹•f%RÖŸ!UûXÜçnø &8àë e¢w³2=‹ßánxŸ»á»˜¦DÁŠ6ñÉ´°•é!XöL]î"À®©¸‹ …è”t¸·’Ìc1ü¡Õ‚h"Å£ò>wÃ7!£ÌR+øb¦ ¾0=‹ßánxŸ»á§˜¦{8.@Úäfjaz‡=Sæ7ؼb~º'ýbxå°bôd®6üZlÒÿ×à·÷¹~™B ¬óÌ/¾›‚Åïp7¼ÏÝðÓ…nˆÍcêÉdßMÁâ°gÊâ3I#nRX ×Á­9fÛÄß’¬GÅ^ÑåjIq7¼ÏÝðCÈz¥ÅåšÝ1ÞÅwÓC°øî†÷¹y™›ÂÝãßñ„[˜žEÖ݈†O¬PfÔpÙ>*¤Ö0ÏÇ#¹JöiÔ@!_ê@½öT_¿ìs7ò4BÅÖP$¬Sîfazå;Üìs7r2(^Ö‚ÑÑ2Ë4¦‡`q\wÓÃË`²MQL¨IöiÄšøÒÝ©qÉ àŸÅ\P©„É\¹; Ùçn„Ÿ‚ï^½¨¹T›èÝ,LÁâw¸Ùçnä)¦‰prGf5ó‹ï¦‡`qXw©¥pi ’÷l¾h˜)ìU êX9!tÌ?‹cÖª=`™ºÓ}îFôYY¥G¸Ÿ¨ï¦‡`ñ;Üìs7r2µÇÛ¡”E 7ÛÅwÓC°8¬»©eÄpÅ,¥œ_lªl]:wõ Éšß»‹!’ßÂE‚‹Q÷¹y[­Ðs/ä3ÙÅwÓC°øîFö¹ywÂ܇ââlßMÁâ¸g*œL£ëÊ^ ¥îúÿóáS{Uj¨3"MÞ/â⇜ qªçôQeŸ»‘‡á>ãã*—É.¾›‚Åïp7²ÏÝèMÈDUÙƒÇ;7ÞÅ…éXÔaÝ ‘4W‹7ÐÝz²gQÁ0&Iõ_‹#ñÓ‹éŠ'–Á¢îs7úÓXsbv3m,.LÏÀ¢~‡»Ñ}îF›ri‚ϸ…é!XÖÝ H×àONöitÜÕ“(KÞVR7¼š·†–]ã’ãQuŸ»ÑG€8~ÁàèYçÛÂô,~‡»Ñ}îFŸÁß ˜ÚLÍoaz‡u7ÌPu·ûªüJÖÝtÌ´éÏÕ¥jïÅñ¸*‹*UIñ¨ºÏÝèÓÕÍkeLêuaz¿ÃÝè>w£Ïàï ±²HŠº´Ù.¾›‚ÅaÝ ‡?+aÜ`+Y¿Èh”€±S$œI¿ÈÄÖ] 3ÖRu7ºÏÝèSL# ½ÞkE7驪`ñ;Üîs7úÓ°54°C«~–/¾›‚ÅaÝ ‹Tè~;„o8É£v´jr)ÉfÏÝõ_‹[-W \„«9¿¸ÏÝèMÈô2YqðLvñÝô,~‡»Ñ}îÆ›&  3Í&½¯LÏÀ¢ ën®µÇ»‡‚RJö/v•^+œbÄ›Y8”™AÜ9Žð°,Ú>wc!Sºƒ£²ˆ‰'UÅ Ó3°hßánlŸ»±ãÐT‰{©³]|7=‹ÃºA :õÐÕGí£S y_áä<ŽKØxdáÑ;™Ââ>wcÿ†GAäª_­4“Lcaz¿ÃÝØ>wcÏð(Ž·E Æ?Ô ·0=‹ÃºE‡Yø(*ÜRX ×Ö0£ŠwD›I½›XÞ”¸à!§±aûÜ=PF… ÇZç'ê»é!XüwcûÜÝ„L¼h„ª’Ša“]|7=‹c½hH:»5ô²gyÔ€ dÒ -žºÓøYÁq8Th<§¸Ûçnì m˱3¹ÌvñÝô,~‡»±}îÆnBƼzÄbqˆ·>ÛÅwÓC°8¬»1‘†ÆâÈÛ<©Þ¥7å",IÍÎ%–Þ¯:!Ëzxã¯]Üçnìßð(vqìÍTaaz¿ÃÝØ>wÓžF(Ô¥¨kÁÈÐñ..LÏÀbÖÝ’\Ì¥d$JÉ> ¬°?¢¹NšÇ?‹#¯öÈV1 8•/¶}î¦ÝP$¸9AÁwøÿÉ.¾›žÅöî¦ís7í&dŠ7t&ƹßeR=µ0=‹Ãº(º’ÔÖ0Sƒ“}½fM6„¸­'ûúcq¸ž†yÈ&9½›¶ÏÝ´Pñjí\f]¨ ÓC°øî¦ís7í‡ñRñGÄr¢³¬azÇz7f‘ñ°/¸ÖÈæ‹‘V•ðkgPIöi`q/×@' dMaqŸ»iÿDlÔ~Êi0/`¼‹ï¦‡`ñ;ÜMÛçnÚCÈ\ª.\(³.Ô…é!XÖÝÄéĆÓz7š½_ì •á§$LÖ/6Ú5­¹™omŸ»iÿˆ»éÐdî6|az¿ÃÝ´}î¦õ»…&"8Q·ˆ=gw ÓC°8¬»i‘bU,u&9¿èQ@©ŽÚòž« ¿É¥ìѽ.‰Ÿ_»¸ÏÝ´{x3Òa¥ä³LãÝô,~‡»iûÜM¿ è+vŠH®ê¬—xazû°î¦s¼uHýÒÚÈùE7iH5Ñ0Å’ân®Å½–ÚÕ¥§úû>wÓïb”ê¹C]'ög²‹ï¦g`±‡»éûÜM§; ä᜽ÅÞLî4¦‡`qXw‘ሩ»UiÒ“:p^K(³aH¸¬G(þñ‹µ#qqZ³þÚÅ}î¦ß„LÜ‚F 4“Úð…é!XüwÓ÷¹›þˆØjW-MlÏ„[˜‚ÅñŒð¦Ü !)*\“}ý¡)f™Z„™%Û§á¸ÐÀðß~Õ—§°¸ÏÝô›é¸³é=4e’õ/LÁâw¸›¾ÏÝôG€8â°ˆ¥  S&™ÆÂô,ën""‹7®™…ƒ¢\/q¸6ÕøÆá>Šwå$‹GW•8ºr}Ÿ»éO1 "p+…k|ÛÉ.¾›‚Åïp7}Ÿ»éýÎÀ%XS=ÙÅwÓC°8®»ñÎŽêlhå´§àÚÈÚÏ‹‹ Y¿a`Lü.ZSw}Ÿ»éw1Í¥5רµêŒG]˜‚Åïp7}Ÿ»ñGÄ&‚Œ› î4©ØX˜žEÖÝ4¦jTJÅP¥ëÆ=Å£ÆêÒ»D†ežì_Äbu·j5¢ûêûÜ?ÄqZô\1ýc²‹ï¦g`Ñ¿ÃÝø>wãqUAÚŠ&ÜÍÂô,Žënu{ÏDR’÷‹Ž«IWÖ"q,Y¿ÈÖðÖ³j—u“ǯ]ÜçnüüÉ©[œ­Ø$ë_˜‚Åïp7¾ÏÝøÓU©Hk³.Ô…é!XÖݘa")þ-«ð¥8}‡xéëV‹?~‘š2…ð·§îú}Ÿ»q}šYPXTÀ2MvñÝô,~‡»ñ}îÆBFKŠI¦±0=‹ÃºÜF4BH¦(IúÅBæŸöpª-;g ¤3CÈßz­¹8ßçnü!dL"$.ПÝ/LÁâw¸ßçnü&d ÅëM0wbV¾0=‹ÃºÂ|)ëñ¡qá“ìÓðz•‹1¢º,‹‘j–ÂÍr½Ä¾Ïݸ?…m77S¢YçÛÂô,~‡»ñmî&Rø[P*ÞT¸OZÙhW¦G`±ÿï³¼4üU •”‹÷«OC2u7‹ÅláÛ’ý‹Þpm Qкð_»x?ï½]¼‹i¼J‹ußwÌÀ­LÀb|ȯ`ñ~Þ{»ø2î®ð®2>QW¦‡`q¬UŒÂìμá¾>©wS#Ñk ‚ÂaÁáäÅí"wôô÷xXEV‹íâ6wÓË#bs8ñû®õ÷•é!Xü ws?ï½]|™§¾+‹tǨ+ÓC°8än´±p„˜Ùì’ÔG­¸$êÂG°?,^‹½p¸Eçë¥Ï`q›»éå!dˆ—N ff²‹ï¦‡`ñ3ÜÍý¼÷vñi„j¦z±}fX|7=‹Cî¦W̘ iÒTÆ/VVŠÅív¬I¿ˆÅMi£\“ûXÜæn" ~ŠL1 «3ÚRfÑÍ»é!Xü ws?ï½]¼¡º"‘o½³|ñÝô,¹›ˆNK ·h®I½Ì3Ö«âC†)鱨:Ú'!ö”Ââ6wgÄ}LJ|E°jРœìâ»é!Xü ws?ï­]¬åXe“Šeã]\˜žÅ:왪#ªáiÐçE‰òîË/²^•sleéÚþøEŽU©j÷õâÿÞźÏÝÔ›a ÐCBÅ“]|7=‹õ;ÜMÝçnêCÈ´ÂŒvi“zÔ•é!XöLUŠwOdöU ‹ÿœ"­BP×!!žô‹±˜‰¬T.?wûXÜçn*ß…mÞô6tÞ&»ønz¿ÃÝÔ}î¦Þ„Œ9cd”Î&·Ä+ÓC°8ži.ìÃtË”±ýøEׯ&PeTJŨ?‹1;þBœœÂâ>wSëZ!YK‡ªÏxßMÁâw¸›ºÏÝÔgxZõÝ[„b:®žZ™‚ÅÉŒð€’—ˆ#G²DÛ_´BÕ»s£ž‹Q3Õ*Í0Á1…Å}î¦Þ„ŒC„<"i/³LãÝô,~‡»©ûÜM½ ™&]S2úlZØÊô,Žg„GÆ×…Ã+6¨Ø%ý¢@øÛÃ'vomI¿üñ‹±8Îskµé2Àýµ‹ûÜM}¡ú5 “zÔ•é!XüwS÷¹º ™ÆÐ®PJ›Lz_™žEšÔÝ`š©B„ÀI¿þu7 )ƒ–Í!ý¯Drù"ís7ôÓÄ™#É`¤)îfazé;Ü ís7DÿOƒç0ñ)ßMÁâ°î¦ˆ¬Æ›wUx§bTäV®(-/Ž“ÃâµØÊÕ Ñ®ú ÷¹zDlá©AÃv⦇`ñ;Ü ís7t GW×Ȫ"öœìâ»é!XÖÝÔbfZãå+ª’Uüñ‹-RÅU ˆùgýbC€[¡Ì¸Q@÷k÷¹º‹i cº`¦Õ¤îfaz¿ÃÝÐ>wCO#T7BÞ»™_|7=‹ÃºŠD!v!ÆÉ9S§Ë»€»QKÕÀý,Ö* ÅáœSXÜçn¨Ýeûè’mFÆ]¨+ÓC°øî†ö¹º¡bç9¶¦›Ø¤gjezÇ=Sî‘1–È1D"Ù¿X1‡`ÑŸô‹±XºEú÷Ó§±Å}î†nBÆ*k© ›E7驪`ñ;Ü ís7ü¯Ê d3â©,.LÏÀ"¹ ß$$õ¬_lN1^]÷H—púãc±5Þ¡:}y9ùß»ÈûÜ ß„L3ܲÆõ w³0=‹üî†÷¹¾ ™xɌőTùäD]˜‚Å!w£ê,MQ-^¾´_Tô —Šw¹õg1†LU×qn ‹ûÜ ÿ »JöÉú¤zjaz¿ÃÝð>wÃw1M“K¦„ÿàÉýâÂô,¹‡Üu«¹Ö¤nxm÷4m»œ´_,h 4VËŨ¼ÏÝðMÈ¿î(ðë¬ uaz¿ÃÝð>wÃO1uˆó©bâçdßMÁ⻉ÿÎP¿keÄ¿<ªä›h(¦ž¾_ŒŸ\*±²&±¸ÏÝð]LSŒ‘Ÿš»´™_|7=‹ßánxŸ»á›© žèöî³ûÅ…é!Xr7¹h]ª\BPéûE¹œ[ü],¿±1¨.Ž,>w¿ÈûÜ ?Å4…„S˜Ýf'ê»é!XüwÃûÜÜ„ŒCÉ·©v›f Ó3°(ãž©®% $T÷Ÿ¾þ”_Tª%¢LÄsšÍc1ÇsÌX«©ÚpÙçnä&dUìá†ãï6¹_\˜žEùw#ûÜü?BÆ)ÞU¢™âôÊô,{¦¨*£9ÿªÏÖÔ]ÿ•òA¶ùgœi._ŒŸ R”Ì[Š»‘}îFîF(\¼4m•Ë´uaz¿ÃÝÈ>w#7!S¼RÇh6¡hez‡=S„ÚnLàm¸`ÌÖÝôãâû^Ò¾ 3ÿøÅX åÈpãG§z‰eŸ»½·FZ¡Š¹ämÖ3µ0=‹ßándŸ»‘›ÁŒÀê¨O‰5ÙÅwÓC°8왢x±»{Äštµåü¢K@±ª5ãÚSwý?‹!î\qtY*_”}îFžF¨‚Þ°Ú"±LbX™‚Åïp7²ÏÝHÿ׬ßfÕ¼J™ìâ»é!XöL1fŒ@‘‘Y góÅÈ%Ü*ˆc§lÝM,nP-ÿ¹XOaqŸ»‘›ÔƒšÈ¬uaz¿ÃÝÈ>w£Ïð¨ðr­7”˜ÎºP¦g`Q‡u7\¯{EF µ,ê\8pŒj§¬>j,6©±`Õ\m¸îs7ú ŠmAD{4SgX˜žEýw£ûÜÞ„ C`‰ø:ý'ÑÍÂô,ën")âÈ×WZ²}ýn%ÀÜÑg¤–ÂâÏb+Ääår*_Ô}îFïbšø ã6”'óW¦‡`ñ;Üîs7úˆØpT\RGóxßMÁâ°î&ŽJ 3êQñ•åQ;n&#:µ9g¶î&‹TÅÄY¸¿vqŸ»Ñgð·C‰U1 l2é}ez¿ÃÝè>w£ÿDl ÊC˜ûT)eaz‡u7œz¸%žÔÓ<ª8ºìŽefënÐkeÆ•qÊuŸ»Ñö$‘†ˆÎ§¦‡`ñ;Üîs7z2Œ:Œf‘ÕÔÙ]ÿÂô,ënðÕZ1ù³'µ§.Âí­)˜ª½_ì×ÌGè‘–µèø¯]Üçnô&dj‹ó&ªq—™_|7=‹ßántŸ»±‡Átªf¥¶Ò&1êÂô ,򡔠 ´!:õšÕ–ºÓ@é +ÅŒ´È¯²ùb,FƒY ¸Ç»ŸÁ¢ís7ö+ ‰¯‘n“]|7=‹öîÆö¹£§<³sÑ@YàdßMÁâ¸î†©toZ;T#ï¾~Œo„VåçLÅbvåR=àœÒð·}îÆžF¨-׆£É.¾›‚Åïp7¶ÏÝØMÈTíÖYQ­5ÙÅwÓC°8Ö*v5"öF­TIûÅÈ©8þÈ95Ûægq¯¸"°8),îs7ö2‰¼¨¡~†ÅwÓC°øîÆö¹{Dl˜ˆŒ¡Õ7ë_˜‚űV±b¤’^ÞÜÓõ¨f^àÉ"ÖMûEsrôZ5WnûÜÝ„ GةȢHp'»ønz¿ÃÝØ>wc±:E§?ÙÅwÓC°8Ö*Æ”(ª·ö=£ÂµyŠÕ»ôšî_tèÜ‹2ç°¸ÏÝØMÈD-§…2Œ w³0=‹ßánlŸ»i7!àGœÆ³]\˜žÅ6¬»ÑðLДèJjWUhJMÎZÝ9}¿‹fyHåTÝMÛçnÚÓ‹¬ªÆÉ3cà¦g`±}‡»iûÜM{¡T:YSÐ…3,¾›‚ÅaÝ Y¤{øà‘2B¼.§wc*•Š ~ëi}TAOcjª¯¿ís7í!d¨#±¢Êã]|7=‹ßánÚ>wÓnB† 2_p…_fŠÓ ÓC°8änZ´.Dd¬CcCRù¢rh†kÉõÿ,Ö®îÖµyŠGmûÜM{ÇÖ„ÿwái=êÂô,~‡»iûÜM{m ×ø±ËìD}7=‹CîF0¨Õ ̽”TŒzÄàä$ð¬®Ù¹ÄFWkÒÝÞ’Ââ>wÓnb”Í¢…"˜Ü/.LÁâw¸›¶ÏÝ´§˜=ë‘ÆCƒbÂÝ,LÁâ»é¸ßCΨÐÎêÀEþPŠéþÅ«ë”sc.¹|qŸ»i7!£„)“(I˜jø/LÁâw¸›¶ÏÝô›1ƒ ®œP#6ÜÅ…éXìC[‹(±‘¢&-}¿X¬•B@“çuàŠ9†"Ç!P×Nõ¿w±ïs7ýEJÞQ¿LvñÝô ,öïp7}Ÿ»é7!S0í¤HC5ÍlßMÁâxÎæÚ¸”V ^={¿Ùïî•å5u×ÿ³8^v?¤-åû>wÓŸF(ïÄdŒJ¡Ù‰únz¿ÃÝô}î¦?Ä{AIÑ$F]˜‚Åñœ©{cG f©ÙûE5aqåzÐ$ýb,Ž”Q avl‹ûÜMÿ'bCΊ“ÚôD}7=‹ßánú>wÓíin ‘㛨驪`qØ3EU{oª«š[¶îF½õŠ”Ñ%ëc±@èÉ -“ªëûÜM¿‹i0-º¸Fb<ÑžZ˜‚Åïp7}Ÿ»éˆÍugˆÙб7“]|7=‹ã9SBá—0˜¸@D*ë㻾,TR³z7±ÏÊj1í©¾þ¾ÏÝô‡a¨f„¦iÏÔÂô,~‡»éûÜß„LªʧgløÂô ,ú¤gŠ©£"T¤¶’Òž‚k3ˆ÷s>Äk)·¿~ÒÜ[³Fžân|Ÿ»ñ›±ðqÆØyÖK¼0=‹þîÆ÷¹Ç¡†´Çá=é%^˜‚ÅqÏÔ5¾U”5=—X;•X×¥kûë;q[îñOùEßçnœŸ‚oEsWD2S¹]˜‚Åïp7¾ÏÝøMÈDÄoa|Ô¬nazÇZÅn½¸qdI¥Ô¬>ªŽP ÏN4/b`\¤‹¥pN{Ê÷¹×`—Þôµê ‹ï¦‡`ñ;Üïs7þƒâng7Ë$_\˜‚ÅaÝ ºZ¦##IÒ÷‹ §ÏE§®[óÿç~±9ŠYQP_R}ý¾ÏÝøMÈ`¤]ô4`_&5p ÓC°øîÆ÷¹Šij5‹dÊ[ä5“]|7=‹­bLO#m @yÖ/ZÅÔ"h$^—wÿ½_¬èÒº#JMaqŸ»q¿Û¼ ã—#À|…É.¾›‚Åïp7¾ÍÝx¹ j %›Ô$6ÜÅ•éXôÿ}–?~šuN ò½§çL‰8SøS+TÓõ¨eøC2w÷óÞÛŧ*|0ˆîÊeâW¦G`1>äW°x?ï½]ü!d¼’)æ›RÄ-³]|7=‹ãž©kÆ74à‰n6_dd{¥[m»©jõ~Þ{»x2ÖÃï·Èç{ÑÙ.¾›‚ÅÏp7÷óÞÛE¹·æºpj%ÎI™ùÅwÓC°8¬» õKP¢B)#ë·üÆÁùO€›âQ¯Ù¿p‹?šÂâ6wãå.¦AПJ‹•Û•é!Xü ws?ï½]¼ ™†Yh¸urTjwñÝô,Žën¬Â9E¨Ù,þÎúÅ*S¾MJ_mûë«b:89÷âõ~Þ{»x2Ý…zå8sfX|7=‹Ÿánîç½·‹!cÝc¨|§±:ÃÊô,Žën”¼Q€¢w.–íÓhŒ_ñ_áw󳘛·îFœÒžºŸ÷Þ.>Å4ÅH•I8òˆÉ.¾›‚ÅÏp7÷óÞÚÅú2Dq„WÁ—qÅÆÊô ,ÖqÝ ¦¸@èÂ+wÍúEH† ш²:p¨,+#ßôwS÷¹›ú *&„š}·IUñÊô ,Öïp7uŸ»©ˆ $ˆªGJÄ5¿•é!X×ÝHõ†q‘¦¦”ꙂkS€Î82,O÷iÄbLR­¨+§ŒÆÆý¼÷vñŸˆ н!H<ÛÅwÓC°øî¦îs7õ.¦A¹¤v+ä>Q[™‚ÅqÝ ‚ØoZIûE„¶èÛhAüëã' >èØÂâ>wSïbí®æ˜¥çädßMÁâw¸›ºÏÝÔgx”wÌ4C/T›°á ÓC°8ž^0µáP9Íöiಾi$WV}òýñ‹±X[ħb‘²æ°¸ÏÝÔ›1È-´È!z÷ßMÁâw¸›ºÏÝÔþ4_Hw3fÔ‰LvñÝô,޵Šû¥TÙÍQþ’ª‹ÅlI•cökNÃÿZ|ŧÏJÖBÇ¿vqŸ»©7!Ó´5W)Óg1ê»é!XüwS÷¹*7Å­E;¡³§OªŠW¦g`‘†u7Ï·V¢ R³÷‹‚Âk‘ð¥ç „óP#€[„ŒÜý¼÷vñi„’pÿE ušèݬLÏÀ"}‡»¡}î†nBF\ŠBpž©OxÔ…é!XëÝÙÔ#ºîá"³ùbiæW›F`1{¿‹!RÌçz`ܯ]Üçnè&d"3DP¡;i3,¾›‚Åïp7´ÏÝÐ3<Šªb,5Ab{²‹ï¦‡`qXw#Iz+øÜ­eõQYÃ…„O•©Žl¾¨g\­Ôø©»~Úçnè fH±¶‡Î,ë_˜‚Åïp7´ÏÝÐ!ÓÂËyD,EHLvñÝô,޹¢Šn^‹0Õ®ûÅŒn8ë…ãˆUÙ¾~VX°Q¸”Ò*¾Ÿ÷Þ.>ãJ «!–æIGøÊô,~‡»¡}î†úÓ”)h–·0=‹CîF<ŽzkÎ\1jÆ/’ ‚Ôîâæ4_ÝÄï~ª—ø~Þ{»x2=ÒRjf‘ALóÅwÓC°øî†ö¹~†Gq«áï4^;Ÿp7 Ó3°ÈCîÆQ‹ÚÁü6öëÆ=£N©13©qM÷/Æb…ª3êK[ªî†÷¹®Ï>]|±j“]|7=‹üî†÷¹~DlÄ*uÇñ=™ù¶2=‹cî†{‡FyDŒ¹Úp¸6ŒDW$@Ñ윩XÌJ–šK|?ï½]|DlL…;"jžUø/LÁâw¸Þçnø&d„H‘ Û,_\˜‚ʼnVqœþ1Õ4"ÆlÝ jJ+<ªkËÝõÿ,öõðBm]Ìúk÷¹~ŠiP„Á‘Ëþg»ønz¿ÃÝð>wÃÏð¨Ö‹è5¹sº‹ï¦‡`q¢Uhà*«8ļ æ6¦õQc1UnBq„­ŒÿÚÅ}î†ÛSð‰±DG夒qaz¿ÃÝð>wÃ!ÃÍ¡gé4Ãâ»é!XœõL)WС¸Q«Y¿¨ˆªL5¾x6_ŒÅ„¡qʘ@’Ââ>wÃO1Í%bñi{Ÿ0p ÓC°øî†÷¹)·p†S)ñK÷n²‹ Ó3°(ãž)cnhµ —žÕ«ÐfævÉPrö~±BU¦4‹¥Z–"ÿ½‹²ÏÝÈMÈ`zGä´‰ñ,ë_˜žEùw#ûÜÐÓ¬ +‘VŸh2®LÁâ¸gÊPûBî ¤ëQñÕ¡ÎÑ1·;ëc1;iC±píâ>w#7!ã(¢b´`Ì2…é!Xüw#ûÜÜ„LƒJ=(ŠY ÜÂô,N´Š¢Áùb )/æMro˜;™­GÅU ­ŠÆˆœ_ÜçnDá –k©†+Ÿìâ»é!Xüw#ûÜÜ„Lµ)U1÷i¾¸0=‹c­â¡uuÌ^Ïq7¸"¬ˆäâüér5p?‹›UB¿UŠ»‘}îFîb±Æ¡\xÂÝ,LÁâw¸Ùçnä±q.i>ó‹ï¦‡`q¬U\Ã1)÷ˆ®¡Õ“½_dŒ—¯ïn–GEuR'D©Ú)U'ûÜÜ„L¸ôfµÒfùâ»é!Xüw#ûÜÞÅ4á1Ü®v×2Ód\˜žEÖÝ0AéÆ Óê²~Ѹ±9Zo—×õÿSwA+Æâ%¥~?ï½]¼ Q®qtD*8ÛÅwÓ3°¨ßántŸ»ÑãОG(Šš©Ü.LÁâ°î&BÓÆÒ “Q¬xÖ/¶‚Ö'(³¤ýbd™äèmÑÖS1ªîs7ú2¨/jÐæ÷ÉŒð•é!Xüw£ûÜÞ„ ®¢EÚhv3µ0=‹Ãºfƒ¬ T2âýKat`]Ðø>u}Eø·Oíº†þEñµ¸ê¯]Üçnôü]s80ǧLØð…é!Xüw£ûÜþ#d(ò}ïã]|7=‹Ãº›HóL0â£bÓ}ýZ‹F^…šì< ,†DªÕÊ-‡Å}îF›bUÙKo}v§±0=‹ßántŸ»Ñ›‰#ß $]læßMÁâ°î5/5bĆyO9­â«5ßÑѱœý?¹¾~÷¦W vYãøµ‹ûÜÞ„Ld¥ÜšÅç¬3 ÿ…é!Xüw£ûÜÝ„ŒHù™“ ý$ºY˜žEÖÝD ØHÝ¡yžŸ¿IU/ܪ¡*>ícq8T3i? tÛX´}îÆþ5B±‰šA÷tÝ,LÏÀ¢}‡»±}îÆnBÆüjE(Ò¤Nî4¦‡`qXwÃ᪷n¤Èú²~Ñœj 7‚kÕìý"»3¤vJ®Ñö¹ã§A˜U•®u6‰aaz¿ÃÝØ>wcˆMÄa˜ÕDgYÿÂô,Nên´ !¡‚r}vΆ£EP^p—§‹Ã·•’ó‹ûÜéC«ÕÎ9Dæ‹ ÓC°øîÆö¹{[!¤6(žd ÓC°8Ö»i?ã0 H`-ë­‹²X>öÍÎ%îb5ÖVç•Ââ>wcÏàïæ­0“ÎNÔwÓC°øîÆö¹{"®Nol›ÜL-LÁâ°î†¨Í,T9|A–G½2EÌEH—Â⽸«VGãEŠ»±}îÆžF¨bPÍ€ÎÖl*ÊÂô,~‡»±}î¦Ý„LQˆ[KDc2Sœ^˜žÅ6¬»©.¸­—bZÙI¿ØËuø€÷©œ­»Áâ96"Üõ ÕÿÞŶÏÝ´G€7‡Çלõ/LÏÀbûwÓö¹›ö B‰V¿†`ëD{jazÇz7¦v ÇÅBNcã?ˆŠDº‡â†2¶?~‹Ý;:Šknæ[ÛçnÚ¿F¨R¨ã’& ÜÂô,~‡»iûÜM{Ši”1!Cj™ªù-LÁâXïFÔ[‹ãй»~tO³šEnUÉìýb,nÔÁ“€‡MaqŸ»iw#Z Zì4Rˆ™_|7=‹ßánÚ>wÓì <{s.u:Ñvaz‡u7Pcë—|·u¾Fbdü¢s7Œ2ÕȬÖ2üü¢£ïQ#_…4kŠGmûÜM{㪩rÇå º0=‹ßánÚ>wÓnBFÀj T’fÑÍ»é!XÖÝÔǨºV\Jôì<çÔœ[|kËiOý,ÆäG‰Üºpª¯¿ís7í æ†8ËlBÑÂô,~‡»iûÜM¿ (.ô !¶ÉÆÂô ,öaÝ ê¼šDæfÞé*Éè†ÇÙ&b\‰zkÙ> ,î]Yã¿ ©zÔ¾ÏÝô›A~8þæ¨Tœìâ»éXìßánú>wÓŸáQ‘ÃGöP9^¸É‰º0=‹Ãº›Žfb'ÌDšÔ ÷Â1®SºO‹»Ë5˜¸¥î4ú>wÓoBÆ"Ž#ÃK8½I¾¸0=‹ßánú>wÓÿ2¨órTîëÌ/¾›‚ÅaÝM‹ÏÚ C§JÎY¿Ø¡wå¥y¶‹#·îÿõÀ¸_»¸ÏÝô›§ãfŒ†ÉßMÁâw¸›¾ÏÝt{š/š–R›TŸ)¥,LÁâ°îÆ"BTrLðRR3ßàÚ$2>4óZVñ¯_ŒÅ-~4µn5Õ×ß÷¹›~2­jüšÊÜ' ÜÂô,~‡»éûÜM¿ ™Zµ оÉ.ÓÑ.¾›‚ÅaÝÕ„ â3Y¿h mMý=7#ü^¬d5g¹¾þ¾ÏÝt¿)n3Ü5•ø¼eÒù¶0=‹ßánú>wãO#”* »BÅv¼‹ Ó3°èúí³mÂ;õÎ’ö‹™*Ç-ŽŸt¾ÈñŽ/k%UêûÜ?„ GjŠQ<ño&™ÆÂô ,úw¸ßçnü!d®‰]¥×YŸÆÂô,ën”Õ<\›bbÏÎ_ôˆMãµX.Àœö‹XÜ[d©á–SÜïs7~2‘;@¹ õÈM' ÜÂô,~‡»ñ}îÆbhÛ+è>ŸÅ¨ ÓC°8žnjáÄ+9´gjÖ/Ö¢½Ø~aÒ/Æb»hÕ’ân|Ÿ»ñGÄÆ$\p<"5ÙÅwÓC°øîÆ÷¹¿ Ì GǸ Ÿp7 ÓC°8¬»‘J5›± pËúÅølÝSÜͽX Fq‹qŠ»ñ}îÆŸÁß­¢° µZg3¦‡`ñ;Üïs7þ“ÅùØz7fÒ§±0=‹c½¢¹ÔQjé’ô‹ñ]!‡V [·ZüíÓh Ò—{l©8ßçnü.¦ÈÜAÝM§ÜÍÂô,~‡»ñ]î¦ÆßwIFÔFŒhX·4=‹ø£]$Ô@{85 Q*FE«…kÅpÓe¶‹Ù)‚[òu€ûÿvñyÞ{»øi®] „D†™ÆÒô,âC~‹ÏóÞÛÅG€ܨöÞ!F4ÙÅwÓC°8ž3U(¢SCƒP¼{©õb«¦"¼íÙûÅXŒëIAáM ‹»ÜM˜Þ„ÌÕ1»S0Ûj²‹ï¦‡`ñ+ÜÍó¼÷vñ±‰(ª;:Úœ‡ ÜÒô,Žõnâ ®ë+”óÏ{oBæº|á‰|›¨ï¦‡`ñ;ÜMÝçnêSLÃ…Í:¤êËìD}7=‹c½žQW+µ§z‰Ãµ±Q©-ºðmë±mü"G–xiíP„õ©;ºÏÝÔG€Øû,Štv¢¾›‚Åïp7uŸ»©7!£µwõÈh0ðs²‹ï¦‡`q¬w#áÅ[/ÂŒx3É£^Æ›²Tó´n8®2 ]ÓÑç‘ÐG}ž÷Þ.>"6¨A—««mÜ…º4=‹ßánê>wC7!›cŠšÉî³Lcazi\wuŒ_B1Ü<{¿È'¥IçϪ”_¤‚3®ÈÎRÜ ís7ôGîñ«i-“]|7=‹ôî†ö¹º ¯Í „cãn›¥é!XÏ™bÅàÏÊV³§´§ èh¸[Œÿ¶U’¬_„ø? µSD„),îs7t2Ô`v‰fÊ„ _˜‚Åïp7´ÏÝÐMȨwÁQÜãøžíâ»é!XÖÝpo‘¸•z ¤¦ûú SibY‘¦5Ë£Æâ‰&ˆ#ŒÊ`qŸ»¡› §OqT6Òøc²‹ï¦‡`ñ;Ü ís7ôox”¶ð‘zŨ驪`qXwé"EÎF×lIiOÁµ‘æ8z[º¯ŸHû5§J¡h‘Ââ>wC!ƒ0W7d2©žZ˜‚Åïp7´ÏÝÐ#bCÝKïVÛ”»Y˜‚ÅaÝp OŒ^&’¦üb;oUŠœöÔµWê…1-º¥ênhŸ»¡›©ÒK±Ò¨±Ì2wÓC°øî†ö¹.ϾZ ÌX§þ Ó3°ÈúÈ)G‚„6Æw×VÅ4‚€Îÿ?úc1®S ;®”ª ç}î†B&’Ìz‰ØÐ,ºY˜žEþwÃûÜ ÓÓ¬oiudU3uaz‡u7Œ ÆHöª© ¥´§àÚX WSÃ=ÖõÅ¿~eôjE"š¨©|‘÷¹~¡&,ÄϪHlÇ»ønz¿ÃÝð>wÃr_7¹G ç‘Tù,ë_˜‚ÅaÝ BTê¨/Èv³~ÑK °Có¦çfÛü,&F9}¤‹¹8Þçnø!dX{k¸Ä×¾0=‹ßánxŸ»á§˜&ŽaÌQ–Ù.¾›‚ÅaÝ ãN¯zvn¹^b\–®ÚJ­Ú5¿X:f¡V©ZrÜ ïs7üGÞ ¤ÕÚTaaz¿ÃÝð>wÃ7!CqDJâ«ÍòÅwÓC°8¬»Q¸EÌ"ëLY½›ð —TŽa,SJ“ñg11¨›ž™…ú<ï½]|ˆ¥às¢r»4=‹ßánxŸ»‘G€¸Y­Ãi¸¼I%ãÂô ,ʰ·Ú˜»hó–§!DáOÝÀÁö¬_ŒÅá­1SËè£>Ï{oëSØÖœ+µkÎÜdßMÏÀ¢|‡»‘}îFžF(Ge[ ÚxÂÝ,LÁâ°îÉW·†H³™¤f¡¢ÙꦘQÓÓ~1+jQ…‹qªîFö¹y†G¹C”§ÐÅ“]|7=‹ßándŸ»‘gxTøŒ8ùÝ Ú‚Æ»ønz‡u7)bHuˆÁ]Thf.±‚{‰ ßz$Æ¿¨» ªUm-®úk÷¹yˆqq±Æß“|qaz¿ÃÝÈ>w#ˆ7wê(öI¦±0=‹Ãºh”VIk`‘²s‰Õ‰›Ô&Û×ÿÓQÉJ‘­¦°¸ÏÝÈSL‰-´¤«èŒ[˜‚Åïp7²ÏÝH¿%º×V®r­ÙýâÂô,Žõnz‰#¸®©õ²`Þ$2äl=ªYéÍ!ÓÁqv¥°¸ÏÝÈMÈTîVbƒ±ËdßMÁâw¸Ùçnô&d(b©ÈˆzÕ2«ØX˜žEÖÝêõcf0oª%ýbc\ä@ *"Ž”öÔÏâÀ2~®¶žò‹ºÏÝèMȰ1H_׿³;…éXÔïp7ºÏÝè3< Ubå­NNÔ…é!XÖÝ3¸:æjÔÖ“~±a˜± ¹?þGjFøÏâÖËE”Ô\=ªîs7ú¯˜w¿(aï}8‰aiz¿ÃÝè>w£Ïð¨Êñ¾bøúäNcaz‡u7® õ^vi2¦ü¢#Òtè´ÜÌ·ŸÅJá“]Ð'’Ââ>w£w1M¸8TaÄÏcŸañÝô,~‡»Ñ}îFŸF¨pwg¤b¬üdßMÁâ°î†w‹þÕRX„ô·hÀE$@ÔÒºáZ@úPœ^Ô§°¸ÏÝèMÈ\ã¬M^6›Ä°0=‹ßántŸ»ÑGÄ&°Õ#£b¨ŸNvñÝô,ŽçLêXK±ÂÅjÒ/öêèô-ñgûc±Ä“êÞ­­ÅUíâ>w£O#”Bõ>Ó _˜‚Åïp7ºÏÝØ#bSZlN¤C­×I ÜÂô ,Ú°î†1¶U›G Ùnö~±î"ä-Ë£ÆbsÅäŠJ-u¿hûÜ=Å4q\O­Ï:ߦg`ѾÃÝØ>wcô™ “t7%žøÅ…é!XëÝTŒ–)( ïÄY¿H‚> ²‚ÉmY¿H®,áÕs³mlŸ»±›qGàɰ¨'»ønz¿ÃÝØ>wc7!ÃÃ]²Øá&u7 ÓC°8Ö»©„øà\Wjù|Ñ%¢:»Ø›|¾)Ù?Ør÷‹¶ÏÝØ#@Ü+c[JkS,¾›‚Åïp7¶Ïݘ=I`$Cæð³ªâ…é!XÖÝð¥ýαU÷¼_4êõúV[®gêgq ïÑDIõiØ>wc!ÞŸµ¬šìâ»é!XüwcûÜý2^4Ò†ŽÁçdßMÁâ°î†zWùB^º¤¸¸¶ZM"”“Ê’« ÿY¬RP‘*}- ðk÷¹{¡œÍ˜ZÄ3uaz¿ÃÝØ>wÓnB†‰]ï/ã]\˜žÅ6®»ñŽ\peßÍ,éãôÁxš†ù6œ½_ŒÅÕâa¾Íº°ü¿w±ís7í&d"«ºÄÿšÔÝ,LÏÀbûwÓö¹›ö2±1âeE•ÈdßMÁâ¸î͇õºØ€’Ò/z'’ÂPe}]ÿÇ/ÆâjÖ\#Aë)Ýð¶ÏÝ´‡‰P˜Œ›Îtæ‡`ñ;ÜMÛçnÚCÈ0UÈ·6Ãâ»é!XëÝ@¶»`¶¹ª·ÔŒ÷.¤‚Úd=êµ8lHÊÖ\ŸFÛçnÚMȨŠ(ǽ™Ä¨ ÓC°øî¦ís7í&d:ËÇ©Uf]¨ ÓC°8Ö»)Ð)mᥦóE‚Pq‹œ‘ >žô‹×b.¡2¤IRXÜçnÚMÈo¯§Nï3,¾›‚Åïp7mŸ»iO1 ±cZMÁœÀÉ.¾›‚ÅYÝ¡4‚ÍÞ4[wƒiÚªLW²u7X '‚DPªî¦ís7Ír4\\.3naz¿ÃÝ´}î¦?Å4áë0?›{ÕIÅÆÂô ,öqÝM?#;¹Š0Ó~1rªHú¬Ü¢ã9¿ØSmz /”º_ìûÜM¿ -ŽúRa7ÙÅwÓ3°Ø¿ÃÝô}î¦?ÄÖ©zAuÉdßMÁâ¸î¦€7D‹&'yT‚Ô½H1\eçi\‹¡«Z<«Ú÷¹›Î³CI¹®^'~qaz¿ÃÝô}î¦?ƒ¿«zAuH¼n³õÝô,ën":Œü¶¸v·ê),µAÑ‘ºUÌdJúÅXÜZüçRXÜçnúCÈx+ñ!"‰˜Üi,LÁâw¸›¾ÏÝôƒ¿Ãe¤("3šìâ»é!XœÔÝ@ŠÀ0¯Ž‹%õn¨¨Bé&\ødÝÍÏâF¨ie_^NþÚÅ}î¦?Å4Ü19ªjä‚3¿ønz¿ÃÝô}î¦?„ K+\ •F³õÝô,ën€¸­Ä ©ž¬_$ôMS˜´ðªY¿AàÞ«ÇS[‹üÚÅ}î¦ß„ AwŒ‰jõYGøÂô,~‡»éûÜ?ÄqjC[›¸èäNcaz}XwñaÑÈŒ¤]cß²~Ó{šŒ˜Pœõ‹PéŠÈcuÖtÿ½‹¾ÏÝøMÈP8Snž®¶É‰º0=‹þîÆ÷¹ˆ1üK+WÒé.¾›‚Åñœ)Ì7 FÄ q–dënZ¸‘lb2FÉê£bñÅtß‘ûµ‹ûÜ?Å4-€ð7k}v¢¾›‚Åïp7¾ÏÝøSL£Ý5ô–ÒäNcazÇu7â…/-7ÈŽzšGõåÈ•cyÕ‰$¼"îS÷‹¾ÏÝøCȈ¸vÒŽî“]|7=‹ßán|Ÿ»ñ§ª@gQ´‰ÎªŠ¦‡`q\wÞ—|ÔÐ×›Í1}±y¬ÕÖü¿ùb,fE@OÍs~qŸ»ñ›1Èdv”3DB?ÙÅwÓC°øîÆ÷¹¿  dAj±£Bd²‹ï¦‡`q\w¹aˆ‚¸FƘ½_¬µ2»ZøUéɾþk±káëºùñ×.îs7þ7ÜÝš%Û,F}7=‹ßán|›»©¥<ò'‘@`Â)äù‡»¸2=‹õŸååAŸô†éÄøŸI¿Q E­ö–ÔG½Cl­b`e&F½Ÿ÷Þ.Ö»)±"òTÆžq¦±2=‹ñ!¿‚ÅûyïíâSL'¥õ.NZƺá+ÓC°8®»é=ÜL$|çHvÎ1GÎ×´‘{¸“¤_Äâx\$ŒI¬),ns7fÞM‰…PîGÕ ýâÊô,~†»¹Ÿ÷Þ.>ã:(îî½tǨ+ÓC°8Ö»i­7爮I~”ô3~‘U›a’/³õ¨×b ïÓ\Rùâý¼÷vñßàï@ØU[à“zÔ•é!Xü ws?ï½]|ŠiH ÓWª¸û4V¦‡`q\wc]µ2Æðâ$ÉúE § ·jðŽY¿‹Í#'‹àž3šŒ÷óÞÛÅgðw‹,ÞÌÁødßMÁâg¸›ûyïíâ¿ÁßL¥Å!®3u†•é!X×ÝÄQãÕó‹QMúE‰/ß4l8ÖlÝ͵8‚c\ÉR¦õ~Þ{»xÓ `A_)£Wg²‹ï¦‡`ñ3ÜÍý¼·v±þ—q¥Vk$E,.LÏÀb×Ý´ˆOQeB*š›ù®-2c8DåÒ{V7üZ,„¢xóS~±îs7õ&d¨H×H‰êdÃÊô ,Öïp7uŸ»©t“˜qÒ›õ8ý'1êÂô,Žën\X¯S7öI¿h­ ‚L!SËöõ_‹«µŽ¥÷¹›Ê79ZX*w†Í„ _˜‚Åïp7uŸ»©7!#¸=sV×:‹n¦‡`q\wãáJGÏ&*'ýbƒ>"AŸzIÝiÜ‹ÉÒQ2˜ŠQë>wSB¦^úq%b—º0=‹ßánê>wSoB¦Q„œÒ¹4©ãŠ•é!X×Ý4êh·”f,’Ꙃk‹CÇ"ãl£LÎÓøYÜU:ÚD2µá÷óÞÛÅö4_(±J|R™ñ¨ ÓC°øî¦îs7õ †ÄÕOà}Ô•é!X×݈ ñO4QR7s ‘ŠQé|Ñb%G¦àÊùÅ}î¦>"6‘–NROfÛ¬LÁâw¸›ºÏÝÐ!ã5Òˆž–ÚfløÂô ,Ò¸î†Ü,>s+.Éá¸"ì%Ü*&Ü“¬¥¿ÿÞ/Æb7¡^(w¿HûÜ ÝPÓø¬Ôn<;Q¦g`‘¾ÃÝÐ>wCw1¢U¿Æñ¯j“»þ…é!XœÍ™"èGy|â´n811cÊ·…‘§z¦~S[— ‚¥¸Úçn豉 ÚD‹8fwŒwñÝô,~‡»¡}î†nBÕÞ­@aÉ&z7+ÓC°8®»)PæÕKF²ä4áÚ W”ÍT´Ý¦ý"z­WQÙËùµ‹ûÜ =ƒ¿AŒš£4jÒ¿¸2=‹ßánhŸ»¡§˜¦kœ‘P“žf ÓC°8Ñ»ªÜ’Œqdý¢ºi1Ž?,_w‹ÙÉРJÕ†Ó>wCO1M|9ån‘û¤ªxaz¿ÃÝÐ>wCw1MÅÌ!z¼“]|7=‹½é&5\“uõlŸ†„WŒ¯ }fíK8ý­»AoG±È8}ÔûyïíâÓ_R"³U)<‹QßMÁâw¸Úçnø)¦iL†³Ò»LüâÂô ,ò¸î&þ5²^Œ9pmñº*õˆrPœ­»ÁâÚ;a,ñzÇï"ïs7|2¥:Âèe™q7 Ó3°ÈßánxŸ»az.ð{œà,Ïur¢.LÁâlΔõÈŽ•ô< 4>º—^úzœé¿ˆÅU":.ÕÖ¿vqŸ»á»˜&v^:ÆÛ)ñìD}7=‹ßánxŸ»á§ª\¿¯:©G]˜‚ÅÉœ©1Ê.ÅH³÷‹Ö1 5"ÖpqI¿ˆÅ]®1…Å}Áߣé¬Ä±1˦‡`ñ;Ü ïs7ü¯ª]ÚÚêÓzÔ…é!XœÌ™rÒˆ¨ÙÅ7I¿Ø E¥è¡ï˜Í¯Åá¡ÊÈ9,îs7üˆØXé{aŸv¾-LÁâw¸Þçnø!d ^[–:SgX˜‚ÅqÝ qïÛ::ô³:pEᢗŒ”eý"G q]Ë&cÔ}î†ïbÌ•k¦&¸ÁŸìâ»é!XüwÃûÜ”‚RæA‰Xl’õ/LÏÀ¢LênÔ"ÄŒÏ\¼k¶µySqŒÓ@‡QÖ/ÆâV\pœò‹²ÏÝÈ3<ÊÉã›J­SÕ¢…éX”ïp7²ÏÝÈ3ø×Ù¬á@tÆÝ,LÁâ¸îF~F’2$zÓ}Ý®ÆþvñÇÙûÅX\‰HzÃLî÷¹yDlb9pÖÊ ‹ï¦‡`ñ;Üìs7r2³yø<í<©»Y˜‚ÅqÝpd¹ˆÉ:õ\/ñ'¯ *¶guàú%=AD?´,Úùµ‹ûÜ<Å4Ä‘ÿE^ŒLp²‹ï¦‡`ñ;Üìs7r2qp£Š$Þ¸ßMÁâDï†Ä+uÕøÌé¾~w¶xk‹7*ë‘üb,nW‹YøÆ’ª»‘}îFnBÆ‹_ñÃâ´œìâ»é!Xüw#ûÜ<„ a¦Y+ñÖ–ÉÆÂô,Žënp±èhìŒI’:p X!šV²~ñZü3™Ø7:~íâ>w#7!£Ð’Ò†'36|az¿ÃÝÈ>w£!)‹¹zõL-LÏÀ¢Žënze /îMÚ“u7\º£¹ˆ»Å!”Ô ¿ãa…O%IÕ†ë>w£7!c]"/‘–É,Ô•éXÔïp7ºÏÝèCÈx±‘EkurK¼0=‹½›Hs+rÆ.–íÓàʆž)t!÷µLÆ_¿‹´³š¯‹Yíâ>w£ÿ™b±°E,>ɦ‡`ñ;Üîs7*ÿœ])¯*Úf'»ønzÇu7ÝK鬑,zËÝiã­¯ì~‰ø'ûú¯ÅÊÒ½×w‹ûÜêÓ”Øê“‘@ðDnaz¿ÃÝè>w£v“uˆL™Ý/.LÁâ¸îÆãÏB­YéÝ’<*_•säèðõµÄ¿ˆÅ²@R®—X÷¹}¡¤…›ëáìj™ä‹ ÓC°øîF÷¹}†G¡áum^x¶‹ï¦‡`q\wÓœÃ%¢<Á"ÐÌúEȉXshmçîú£WƒJµ¶.Úùµ‹ûÜ>Å4ǑыV™E7驪`ñ;Üîs7öoð7õ¥k§ÙýâÂô ,Ú¸îFG`2ýR®É拊îéplÍ87#üg±Qïh¤89ƒEÛçnìßàïÒ^˜Û:ë_˜žEûwcûÜ=P‚édÍÉã½ìâ»é!X×Ý„çT„‹´–ìÓ`¼¯``Z‡"EÖ/’ÅOÅUæ’ê_´}îÆnBÆH:Êýª MòÅ…é!XüwcûÜÉ}õ‹T¤6cই`q\wH —Öȵþ„™©|Q]QgÄ=àœõ‹±Øâت­F ›ó‹ûÜýüñJ-qJÒLqzaz¿ÃÝØ>wcO1 GÕWÕ:‹nÞMÁâ¸î†Äݤ©É•äæü"_“Cº1¡G%é1ä°XàÑà‡RXÜçnì&d´ˆ޽iu¦=µ0=‹ßánlŸ»±ƒ¿QBŽÆ×IUñÂô,NônȺctdD‹–ìÓàˆ2{1«XÎõÿ,öXÉ¥Së9¿¸ÏÝØ#@\TBñ¨gYÿ»é!XüwcûÜM» V‚¬[é¥è$F]˜žÅ6¬»!ŒQ0¥¢dóEÜÞ”È5á“~‘ðÒwè²FdŸê™jûÜM«O‘)‚–KBÀ&ùâÂô ,¶ïp7mŸ»i7!c¨p¢8+g=S ÓC°8Ö»éÁ¦d-:§°øÓˆ±\/¨X§|ý"_ÒÜäd^Só4Ú>wÓžáQà{kÄãã]|7=‹ßánÚ>wÓžáQn]/=Ÿñ¨ ÓC°8¬»¡ï\‹Ü­s³Ül¸6CVåh¶à;a®Ê?S=SmŸ»iÿ×Ò:dçæ»ønz¿ÃÝ´}î¦Ý„L×Qb–å&»ønz‡u7á“sžš"fÌæ‹×°Â†‚xtNeï{©œ äerÜMÛçnÚ#b¸j‘CyR¾0=‹ßánÚ>wÓnB†1-Z0øašõ/LÁâ°î†Lq9x€4H¶î†ÝÀe²¾.cûë)"‰øX¬qD¦ênÚ>wÓžF(¥¬™:Í2wÓC°øî¦ís7ýÿ5BµnETãïâÂô ,öaÝ Iƒæ”жÚJRîÒ*ÜOMëÀa1+ä¹p‹}Ÿ»éõ_óEü¸HmÏ¢›…éXìßánú>wÓŸbš«L¬²r)k.LÁâ°î†˜Zs) g®GR‚"EWIÎ%Æb¡^”*~MaqŸ»éO#c˜CŸ6-laz¿ÃÝô}î¦ËxR+±7½ÉLaaz‡u7}åÞ¯J¶ï”ãQMeE•ÜÌ·ŸÅ1½Aø&׿Ø÷¹›þoxzƒKìŽöI¦±0=‹ßánú>wÓŸbš¦,äÍÌÉ.¾›‚ÅaÝ UÑÈr{SŒ{ÊÞ/réŒ)̽¸¬Gbü­»‰PðRsD·GJ®ïs7ýi„ŠCG¤î>=QßMÁâw¸›¾ÏÝôãH¯®D/6ÛÅwÓC°8¬»¡ÒÐD\é[Ò/b °yœ>†R•¤_„û½tëÚ©þÚÅ}î¦û#œqUÅ‘á³)š ÓC°øî¦ïs7þ4BÀ¼tpðã]\˜žE×ݔLJ’¾&uÃ9¢ÌZ(rÌQMÕ†ÿ,†fywWõ”_ô}îÆŸáQñÓ”{w‹äv²‹ï¦g`Ñ¿ÃÝø>wã7!à HxêlæÛÂô,ënâ_s|fµJ÷/r1†öw‹¥ëŠýb1e²BO6‡Å}îÆŸF(Ã0Tšêìfjaz¿ÃÝø>wã7!S#¬¤L¡ØdßMÁâ°î&r/rN\œ[Vw—6G€*§=õ³„³KïÍRõ¨¾ÏÝøMÈDFìVŽƒc¦”²0=‹ßán|Ÿ»ñ›1ŠÈ“j8›u¡.LÁâ°î¦¢ùÐЃHîi¿HÒàÖŠªr³P÷ZÀvykˆ«_»¸ÏÝx»i5pkÔ{dõ“]|7=‹ßán|Ÿ»ñ›!cÛ„:ê…'»ønz‡u7U+9ÆFÅ”³¬_ì@°¨–J%{¿È=àØ ¦לV±ïs7þÓôø–Ý |ø,_|7=‹ßán|›»¡r2-BÑØm>ÖžZ™EúßgyùÅÚª] î)Û×Ï¥r€Å¥%çLa1&ÿFH€ÌhlÜÏ{ooB&b–B'%£oy¼‹ï¦G`1>äW°x?ï½]¼ ,‚T&ÇË:æQW¦‡`qXwŽüÒbë%¢Íï4yÂc¿èµ«jÇ„­t=*;U‚ž…KdØ),ns7Tø)ðH© «Ž£›•é!Xü ws?ï½]|ŠiÚ5ª ÷“á+ÓC°8¬» ¹Ã„s«œÂb¸¶ˆMYÌ-r¿–­GÅébø5ÍĨ÷óÞÛŧªÆ¦ [?p?ænV¦‡`ñ3ÜÍý¼÷vñü­µ¡C¥O¸›•é!X×ݰµÕpmYÒ/=@xÕˆ²ù"¨·j_íüÚÅmî†Ê]LC=Õcnë,F}7=‹Ÿánîç½·‹O1M½2‡ë œ¨ï¦‡`qÌÝÄ\U!±Ü,…E ResïÊ›\Œz-nBWiü¯·¹*O1MC+[ €ÉdFøÊô,~†»¹Ÿ÷Ö.ÖGÄÆ®¢ ã]\˜žÅ:än¤#>uEG°_#S~1½îÊalvΦ°¢Y‹¥ôžÑظŸ÷Þ.>Å4™m¯(öicuezëw¸›ºÏÝÔ›Qí­¡J+^šIŒº0=‹cî¦4ö8D0[X¯¸Œ_dÜfÔBÐ3¨)MÆŸÅ蛺FW”Ìýâý¼÷vñi„êjšwE'UÅ+ÓC°øî¦îs7õ&d´¢¸$P\ú‹ï¦‡`qÈÝÔÊŽÞÅR#®¦ìýâ%NÃ…³<*J›†[Õø/¤°¸ÏÝÔ›!%P‹ "×À­LÁâw¸›ºÏÝÔ§Ê#†ƒ<ÿ´qez‡ÜM¹(ÃHŽ,¯^” @i…×òQën´ ("²Ei–ó‹ûÜM½ ÆÄðsÕûDÍoez¿ÃÝÔ}î¦>"6‡dS‘HÌxÔ…é!XöL]ñ/.FÙzÔj] Ö*±§ç/ZonGX¥Lmøý¼÷vñ&dâs¶Ø\ Ì*6¦‡`ñ;ÜMÝçnè!d:ÂN4ÙÅñ?ÞÅ…éX¤qÏ]eBЦpŽé9S¥Gš)¢‘'ççL¡ãpÖ’šms?ï½]|™‹¸ck¥Lz¦V¦g`‘¾ÃÝÐ>wCO1†¹UÑΓ»þ…é!Xk+ê½ ÛÅ…fõQK$WÜX+fbdýb|¿wnâ¶Æñk÷¹z‹ŒMÓ“)š+ÓC°øî†ö¹zˆ‹tg×Z|¢á¿2=‹­âˆÅÈûÕ:¥YÝððÓ˜ÞY½›X¬£å³¥4üïç½·‹O1M¿h¦lŠÅwÓC°øî†ö¹z™~)Â8XÒÙ.¾›‚ÅñŒðBÝ‹t&tMúEr®Ì½–Ò+—ä\b,nÅštTäüâ>wC!câk%Ð?™ìâ»é!XüwCûÜ Ý„L¤~V²üe¢ ¶2=‹ãáõ‚»¸‹¥z¦.§JU 2Bê&ý"ë5™K4£îs7ô Š8*}MÚ¬6|az¿ÃÝÐ>wÃÿ Ñîh¹Lî[™žEÖÝ0FK¤|‘8JK꣒]*”^#¨–¬»ÁbQaê~‘÷¹¾ S3ÒéDåvezù;Ü ïs7ü ŠtÊœ•›naz‡u7lˆÉ„Mã ÏÍ|ûˆŸê®¸ ‰07Ù×ÖW±Ö‘kŽ_»¸ÏÝðMÈ`NA½C¦o²‹ï¦‡`ñ;Ü ïs7ü2b(-)¯À„G]˜‚ÅñŒp׫ÓžÌSþÉb¤UÝJ•ÜÆÏbejŠZ%]–ÿÚÅ}î†õ¦¸ýÝÜZ[“]|7=‹ßánxŸ»á›d5^JäT}¶‹ï¦‡`qXwƒ*TVŒ&RIê£{µ¯F¨ýKúEô«/Í“õ¨¼ÏÝð-bS"ì˜m‡Éß“]|7=‹ßánxŸ»á"6R¹Þ›ð¨ ÓC°8¬»­Gí³Í³:pá *ô™ã.=YŠÅÚ*C¹¼¤æiÜÏ{ooB&¾Ûpо'»ønz¿ÃÝð>w#幨Ðm&/4ÖG]™žEÖÝ„SƒêBÌ»¯?ã J÷U D)ÙûE,îfÞYègÚÜ6eŸ»‘‡Áœáj•1_q²‹ï¦g`Q¾ÃÝÈ>w#7!ãTjäS/Î,_\˜‚ÅaÝ(Çgm$z ûNúÅÒQŦ˜ÊÔ${¿Xz¤ï‚{Íb=•/Ê>w#7!Ã;ÈÀÎvñÝô,~‡»‘}îFä¦ÕØqIÑ´™_|7=‹Ãº›ð‡ÜÑvI‘äfënªcÜ[+®ùfÎ/Æ©U¤æyèÏmÊ>÷¹¹‹ip÷ÉiU-Ó]|7=‹ßándŸ»‘GĆ+$]J‹øsr§±0=‹Ãº±È1•bl%9—3™Š£ÚyCVñ÷.b±FÒ9R­©ûEÙçnä.¦Q C:™m³2=‹ßándŸ»‘þ\TĦxA´Nn¦¦‡`qXw#âDµ@–‘É’ùbU®ëZí­¬KJÿøÅX§q\3ÇÝÈ>w#ˆ¶ß4|Ø„ _˜‚Åïp7²ÏÝè¿bUÃ[ã•d Ó3°¨Ãº ]ň©ø#7 5¾1áNƒ›4 8¥4¯Å„Ñ8ÌÐfMaQ÷¹}™g¤w2Ñɤ÷•éXÔïp7ºÏÝè3<ªF&›cèžìâ»é!XÖÝH !þŒ©WéÉþÅZ4ë½:éc±÷ª—zx®N÷¹ý7ø»£þ=É2ë_˜‚Åïp7ºÏÝè]LcŽ@ Ô4™Ä°2=‹Ãº¡îR½h+¸ëËùEô÷^»F3% øg±£–•5r3Zþä_»¸ÏÝèMÈTmšK“}’i,LÁâw¸Ýçnôßð(vGj£S ÿ…é!X×Ý„W"Qô\ZçT ÜþﺘĨ©F5±˜+¡c7Ð,uÿÚÅ}îFÛCŽzS‹ü¡—™ÆÆÂô,~‡»Ñ}îFŸF¨^JoÄÿ2aই`q\w>ɹA Î%óEn‘Si…Z†NWñÏâŽyqq¸Ð²[ë×.îs7ú2»C¦—¦ÈdßMÁâw¸Ýçnì&d ¤hAÍNÔ…éX´qÝ bTHdǫǚª‹”Ϩxé†A0%#èÈ?‹áSK ¸Èºúî¿wÑö¹» ™Ö\úR&»ønzí;Üís7v2­E>/lëR' ÜÂô,ŽënâÔh|½€áѳÚSÎ%2ÍZTŠ]½Ä›BÇ—ÆF÷VÇK”s©Xþk÷¹ã§ÈÅEðy<™¾2=‹ßánlŸ»±›!\·fNä3,¾›‚ÅqÝM8D‹^â½ó¬V1ʺIÅ —ËáŸÅµ;C®“,ÿÚÅ}îÆnBæ"r¨f˜L¸…é!XüwcûÜ=PŽ×|2—xezÇu7€(æLZ5Õ×§AQxgŽ 3Óˆü3Û†œÜ¤ˆõ¦Ëdó×.îs7ö âÀXã2Ë4ÞMÁâw¸Ûçn¬?²`Þpwm–i¼›‚ÅqÝÅé¡ PzqIé†[øЍNäš ’ò‹‚k‚ù6ÝjMq7¶ÏÝØ#@Œ~i oW]fX|7=‹ßánlŸ»i7!Ó1¦VÁM´YÅÆÂô ,¶qÝ ¦«A‰€’}ÿù?+3 )žâQ±eôá—{Gyz‹mŸ»i±ºKo¸žõ/.LÏÀbûwÓö¹›FüI¼1*K}¦¬¹0=‹ãº›&BÈø7‰70ç[‡ £R¼¸Âë+Âß»‹Å?%|s*FmûÜM{ŠiÐð,ñ)k/“ê©…é!XüwÓö¹›ö þÆ0ETz•6›.½0=‹ãº›NÊE¼P¸õ5ƒòÛ/:î$½•ˆÉÙS1êµ8œF`,d’ŠQÛ>wÓB%ì]J­uÆ£.LÁâw¸›¶ÏÝ´›)Å1ð³ÆæÌôn¦‡`q\wÞ u{R’ÚSUÎC®¦¿¤&#Ç™%Ü*FzdêQÛ>wÓžF¨R#/†º[í3¿ønz¿ÃÝ´}î¦ÝÅ4fUœ"©² ¾0=‹ãºÓHù*;š9©U\Éã+÷8{ZéYí),fÅ,'ñÁ8¿vqŸ»i7!iòø ¦ÌéÌ/¾›‚Åïp7mŸ»éå_àÉØ—øÇlFøÂô ,öqÝBä"’ÆÊUÖ‘â¿(Í1˜&ˆFÖ™ô‹±˜0áD g‹}Ÿ»éO1ÍÅ0E0j½É.¾›žÅþî¦ïs7ýi„â>Qò­Ò'µá ÓC°8Ñ»‘â×õ*-7Oel­T6!uo¶”Éø[ F·T„õ¦°¸ÏÝô›1ë'‡–YÅÆÂô,~‡»éûÜM™ë7n ýdßMÁâ¤î¦Ä_ŠÊp‰Ü/é;C›£Špúã1:¶kdgÐòOéÀõ}î¦?ãZ•ˆXš8Ïz¦¦‡`ñ;ÜMßçnú#b‹âäWh³]|7=‹ãº†d9E’ä’í%Žï.•Zä~á_³ÚSͪ)ÚËÂ5¦òžÏÝôG€¸E ½–:‹nÞMÁâw¸›¾ÏÝôGÄýÝ5Â0?“]|7=‹½›(±i¼z¹9S()eºÆ'ZÓÖ³þ±¥ôPdtJÍÓèûÜM¿ î¥p8ÿŽœÉ.¾›‚Åïp7}Ÿ»ñ§˜†¬ŒW¨ñÊŽwqaz}\ws•„FŽ+VR¾ŒVq5/A*GPÇ)îæZÜÊãðÒžÒØð}îÆëCŽrÄÓ ÉSžä‹ Ó3°èßán|Ÿ»ñ›Ñ‚Á˜Åª’L`q¢wSWiT¡UœmCâDlu]Rºá?‹Ã©öxbÜ8Å£ú>wã|·Ð“­!6|az¿ÃÝø>wãO#TdêNde¦w³0=‹ãº›8ÿ­5´-iY ÿ«Õ¢ŠPÁÔ¸¤_ŒÅ˜Ž¾ðk÷¹¿ GE«ÕYêÂô,~‡»ñ}îÆoBFµ3†M@&i’/.LÁâ¸î&>schIðê©9SáÚÂÿˆñî†_LÞ/b±EK :)îÆ÷¹¿‹iì’¬ƒD9j|Æ»ønz¿ÃÝø>wãO1M“@Á§Î&1,LÁâ¸îF¬0s 0unÙ™o`8 Šo˜ûzœé¿ˆá ö'ü/IØ_»¸ÏÝø#bãáê¡ËŸ|1"T²k>}ÍÝi`Ì·µK`»‚MMÞ/bqÁ¥¤ºj‹÷óÞÛŧ˜¦bÖ£T«2™3µ2=‹ñ!¿‚ÅûyïíâMÈ€däèj…Æ'êÊô,ŽënXÂ-†oT4Zgg„w Q4ˆŽCA<écqoÞÐBŸ‰Qïç½·‹w1è# öyt³2=‹Ÿánîç½·‹O1c„5+6h†ÅwÓC°8®»©ñÒ)d.œ;eyÔîqð@+—8©»~,F¡æ°B.Sws?ï½]Ô碢÷OÇåÉ.¾›‚ÅÏp7÷óÞÛŇÁÉïilÍ¢›wÓC°8®»)lм X9S–Gu¯êV:Sz*î4­Ä[ß1ª*…Åmî†Ë#@Œù;Qf)³]|7=‹Ÿánîç½·‹ÿsœàB$4=QßMÁâ°î-%]¨J«%=ó Q€TL¨©‘m&ý"Sü¯>×Ô\âûyïíâCÈ´"±-=’‡iÖÿnz?ÃÝÜÏ{këÓÕ”ð¶F,7ÑžZ™žÅ:¬»áVj®`SN“1€\+@Ø”ó‹±ý­: 35p÷óÞÛÅGÄÆ0褄o4¾%^™žÅúî¦îs7õ_#Tœûm°:Åâ»é!XÖݰˆôá"Q+%YÊ(d­ÕyEcÒ/ÆböÈ­QºÞøk÷¹›úÓX¯á&“JÆ•é!XüwS÷¹›z2 nŽ9rÀX=ÙÅwÓC°8¬»AžÇàRÉïŠ)¿ïl…K_)Ù§Åè×jEcœ3XÜçnêÓÕ5¶¦Æu™Ä¨ ÓC°øî¦îs7õ&dèÒ¶6L˘ìâ»é!XÖÝpa-VjEEZFâôò‹Ôj ïá­ÅWÏæ‹±X¥T wÜÖ W¿vqŸ»©!ƒAÆ‘¡NvñÝô,~‡»©ûÜM½ˆ½)Û5Ëz6qez‡u7tuwdl‘ñeý¢H•‰&d(sµá?‹+7¶@²zŠG­ûÜM}Dlp›YcwÂ…ÏvñÝô,~‡»©ûÜ Ý„ õ®-^¹ª•Æ b+Ó3°Húj­ÃìVQ£¬_Ôj­Kc기OúEL&ç8¹âç’g46îç½·‹õ_à‰Ã3gu7 Ó3°HßánhŸ»¡‡ixiså' b+ÓC°8¬»¹& sñSkò~‘óâ8‚Û8ƒz²‹Kn?²À),îs7ôˆØ„ó?ç—1aই`ñ;Ü ís7t2‘ü5‡›ô/®LÁâ°îDhïÞ0lJ²ºál ]È":ïBY¿hJ^å7­§46îç½·‹O#áÖ—ãCfÑÍ»é!XüwCûÜ Ù½5¸È.à&ÚŒ[˜‚ÅaÝ ‡öYäÉ>pÿå¨-pü3ó-ãáKÌ(ðdŒºÏÝÐMÈ %\wÕÉ'ùâÂô,~‡»¡}Áß‘:`FmšÆ¨ï¦‡`qXwCW0%<7îÉ> ¾®øÑ/UÃ-&û±˜P,€Æ©’ºÓ }bêhE¡kÊédßMÁâw¸Úçnøi„’NLãNfÜÍÂô ,ò°îòùb¨Ã,™&êvZE;rÚ/ÆŸÞô»®úï]ä}î†BšRÍ8|Oî4¦g`‘¿ÃÝð>wÃ7!ƒùm*rµ"LêQ¦‡`qXwÎÜ+¤4^¿Ë;¥ü"B€^#ª+?R~‚qt DSw¼ÏÝð3<ª¨‚ejJÓõÝô,~‡»á}î†ÿ5B¹t¡Bæ³ ÿ…é!XÖÝÔFìhͯ-Õ3׆&1ê%þ"Éy±˜´Ê{Áxò÷¹¾ ™Æ¸B­è¿(3¿ønz¿ÃÝð>wÃO#TÇÑm¹ ÏNÔwÓC°8¬»©>5o¢Yµ_ÒUº÷ÚÓù¢`dœk¯½—÷¹~Ši,ðՋƱ1«d\˜‚Åïp7¼ÏÝð#bÓ½F$fµö‰âôÊô,ënp<9F¶1T¨²ùbënUŠiSçÔÆÏbHX†kÔº¾ùµ‹ûÜ ûxRƒø££}²‹ï¦‡`ñ;Ü ïs7r2‘A~8r‡>™ù¶2=‹2¬»‰èÒYÜK|“l¾Ø<`ˆúîq-[Ú z¨(f-£z?ï½]¬Oy"Eï ƒIÖ¿0=‹òîFö¹yB1M¥ÒªNòÅ…é!XÖÝ´~Q/˜Þª_&Oxœ/Và’Zü•Ϋ–ëB%rjþâý¼÷vñ!•Åø+2ãI¦±0=‹ßándŸ»y„3Ô0Ub“èfazÇz7& îa{%ƒE¸¶ª éž„kË2¶¿~¹ªÔjË勲ÏÝÈÓEèÑjê›ÕÝ,LÁâw¸Ùçnä&d*ú%Ò* ˘ìâ»é!XëÝt.‘©R±z¥|’É«uÆh± ×ö7_¬w\z¹J#2XÜçnäeMu6¹oez¿ÃÝÈ>w#ˆkAÉ¥”ytónz‡Ü “¹ôÖL}Júň/ ¨ÁmÙzTˆC™Ïæ°¸ÏÝÈSLSk‹€¸r—™²æÂô,~‡»‘}îFoBãÂÏ¡¯hÆÝ,LÏÀ¢¹+rÕ ©›´–Í-r+§ÀSÁ$é¡ñ¤Êµm4yü÷.ê>w£õ_‘)áÓ^7"“]|7=‹úîF÷¹}%w«TUˤ¯az‡Ü JQk ¿ˆj¶Kú;ã1Ï8¿Éq7?‹#ˆ(N¥ÅKaqŸ»Ñ‡Qа¥I‡ÑdßMÁâw¸ÝçnôÕ‹CXxæßMÁâ»qqT£¶âìåÿãîosuÉ‘¤Al+Ú@%Hÿ"}ú£  `€W½Ðúå'x;Ïí`>?œÈ®Êêêö“qîÃÇÂÝææ—6<“XŠäFÄöQÏ/Zi­&Ø.KÍiè>w£ƒ©ZܯUmr׿=‹ßántŸ»Ñ›Á—Õ1ßÕØ¤ÓX„‚ÅGîÆ]*‰³acLº_‚Ñq~Q”³w£c : ²ËYuózg¦¢¦Ö¨1{Ù«Ôd^$W¾dåE%»—?\´;<RÚpÝçnt˜Ø´(„+\ˆ}v§±=‹ßántŸ»±a@l…+a61:£çS\„žE{œ™òέ5ØVÔ ?—«¨¢ á 53õóÃÅ[Tó*ñd°hûÜ 1M‡ñd< ;Í'§øzí;Üís7v2V·g´N“ûÅEè!X|œ™Š6‘ݱ[X ¢IæÅBlE¼à$¹g ?ÌdcìÉÕö¹ãa¹Å·6,¶šañ=ô,~‡»±}îÆ†˜SP^0~Þ'ÚðEè!X|œ™êî?ÄÞ8…ÅkÏTã&½kôšëµm¿O1~Ø\],>±Às ‹ûÜÝ„ Êè€YTâ>›ë_„‚Åïp7¶ÏÝØMÈ<ú°I;êÏÉÆ"ô,>ÎLõn^Àûz‡6— 2Ô9FyRŠŠ´HŽŽ),îs76LlàvÚ¬ºëLU¼=‹ßánlŸ»±1U” öG™Í¼§¡‡`ñQwí"Sum¦j¹†Ž\ânƒÒ(—ã‡EX#cí[ ‹ûÜ B†5ZˆøáÙæ¾Eè!XüwcûÜMû·q|[´ªLòâ"ô ,¶GÝ <@Í`u¡Ò9u×CÇ^‹G»×­I.p9®Ý™sûÛ>wÓê GKoÅð+ONñ=ô ,¶ïp7mŸ»it·ò*ð­•Ž«ÃÉ)¾‡‚ÅGÝM™ûwÕ¼þlAÌäEŠ:€¢HÅp>'÷L]fÑ^ƒ4âÜn›¶ÏÝ´!¦©5’0–¶ÚlÚfz¿ÃÝ´}î¦ 1 ĢfŸiࡇ`ñÙ«8¤˜`Çò¶’ÔÝÐpÆUecUÔ_y±` _KŽF ‹ûÜMÓÑ*¦%ASùäfjz¿ÃÝ´}î¦ ›8úø¢‰Au99Å÷ÐC°ø¨»©b|ï¢Z¤~Ñ/Û3SW%(B1&}M…þ>E\äÁ±ª‘Ô’»ÓhûÜM» ¡èNÑË-³S|=‹ßánÚ>wÓnBF Á~ÂãÝ]']ÿ"ô,>ûÝôJ0¬-Ò#'ób «µ¢ÝJ•”îç‡+.5aî¼^0þë÷¹›öGLc.u‹¶™kÑ"ô,~‡»iûÜM¿ ™ÒZ—·±‚žx<ÅEèXìÜ Ç{K5Ä‹'yTLõöæQmt·ìž)ü0¾òø Xf°Ø÷¹›~2yq"¾D{“S|=‹ý;ÜMßçnúWi«êä–xz¹GÃÆåg«–Ü\…ņp”¨pÌIî%ÆsÈØVižÒÀõ}î¦ß„ _‡Ó;^““êfz¿ÃÝô}î¦BærŒ´AØOø|Šï¡‡`ñQwC%š[íE⯯âD^t+½tëXÅ꾉ÿü0G•¥*«ôå¶¹_§¸ÏÝô1Å[nñÆŒMNñ=ô,~‡»éûÜM¿ ™ø¦TcŠRŒÚ¬ºy=‹º¡óë),þçŸæ5@ÜDÕŽ),â‡K<óJAýj ‹ûÜMbšââ}¢2ó _„‚Åïp7}Ÿ»é!8î*xÖ/¾‡‚ÅgÝM3‡.šFÌæçò¢] ÂÝÜ£œ»ô¨‰¼hýé…E-‘SXÜçnúŸåQìØdeÛdfjz¿ÃÝô}îÆÿ2fÞ°&°é„ _„žEän*AÎn•¢¬®-é®Ô¢¢ƒ°¡–Kùç‡ÿQjT©Ë¤úïSô}îÆÇ jᨦ£5žmEY„žEÿwãûÜß„ ¼ˆ¢“7!ŸmbX„‚ÅGî¦F·ze¶ôž)a-¸¸ y™Ú~Ÿ¢°X-]ÅÙ{Kõ‹¾ÏÝøXü9¼3U™1p‹ÐC°øîÆ÷¹„ŒG#Elñk“uzu7#'Žˆ &’û4¢?ækýbé’ý"G6„úi<™sXÜçnü‡é•¦ Æh¢»Y„‚Åïp7¾ÏÝø d,ƒF“çÀçS|=‹ÝG^#—kÏLr/q”â-J ‡^j‘*ÿü0Å·ÝH´0/3ò¯SÜçnü±Â’¹l©›œâ{è!XüwãûÜß„ ÷ÒãÕ»ú™zjz';Âq§™)•syñÚŠîîâ œªQñÂÅ\Qžb“ÇòÉ¿NqŸ»ñ±<ªbîÖª}v3µ=‹ßán|›»‘2¡Z‰Šó¶Ïyqzå¿–×ý"K\Þ.LRrÿ"ÖL˜ÿ{Ê "óõÃñ;aó#uíMW?ü¯S¼?ï½S¬wá ›¿l`ÿ™»Y…Åø%¿‚ÅûóÞ;Å?ÄõWT· ŠçS|=‹~7¤MM¬à‚»Y’»¡ZÅ;~Ù(q!rÕ¨ø¼ðï¢ôc"·ÅmîFÊ dz´Ä 7/6™B]…‚ÅÏp7÷ç½wŠƒiÎpšo-¾:“S|=‹Ïº›Èhâà4›ô¢¹Õ›YÔ©ÍôÚ4žÁbüp' ɴt ûuŠÛÜ”[L#QujüžñÛÖçûÅUè!Xü wsÞ{§8Ll޼•à¹0«nÞCÁâ£î†"§5m‚)!k),ÆŸš¿Ò û퉓ÜMÅÝväÅh’¹_¼?ï½Sü#¦±€~µÏšâ{è!Xü wsÞ{§8™è„¬»r@lV£¾‡‚ÅGÝ 5ø“FÓ@dï4ˆI]„*¦=r<*~˜aíQÚµ‚qùÿNq›»‘r2=ÚR2»ÔÂÏJÆUè!Xü wsÞ[§X‡˜Æ*¬ÀU±çù¡g`±>ÏLAîп±S† ýñ*.]áç„­¹¼ˆ•:ðH-¹¤4p÷ç½wŠ·˜ÞZXà·Îäº=‹õ;ÜMÝçn*d‡SQ˜ôM¶h®BÁâ£î†`Xßzu‹u­~ùë®?¾·00Lݦïúf“¢K*¢XKaqŸ»©7!ÓKÜâ` .BŸOñ=ô,~‡»©ûÜMý!dXÇ•xWštý‹ÐC°øìw£Xò„Ià"ê—¿4p¤ñv+ÑkÖÞ,93…Õ6±³RQ§¦°¸ÏÝÔ›!¢Š¡g8@NúÅEè!XüwS÷¹›:kíØ£¤F¸Uè!X|ÔÝ=‹^±y¯ë)ÂßyQ «Å©3läZB(À??Œ˜%£»¹?ï½S¼ W,?V/xwLNñ=ô,~‡»©ûÜMË£ôWÅ Üìúz'ºÂêµ(È$P±¬Ÿ"Æ34MXÖhvf*~Ûœ9ú?ÊÕ¨ûÜMbš‹¯íxåL<6V¡‡`ñ;ÜMÝçnè&d: 1ëlâ3uzéQwƒ¡xýë=ŠÅìÌ”(Ö{GZ¤&™ËIþùá^Pjw­møýyïâMȘ öF‰!ONñ=ô ,Òw¸Úçnhˆi˜\®¬ÑgŠEè!X|ÔÝTÅn³Ú0b_z6/ºVÀý»ôl^t-.Í:\k×7›¿NqŸ»¡±<ª+ƒ¹m°é›œâ{è!XüwCûÜ ý1±a²øÖÅëâɸ =‹º,%¶hù"´¦É~1’G+Ä5Z¿øæ&ó¢ERµæñXìªÊhÃïÏ{ïoBŠï8—®V&›ûV¡‡`ñ;Ü ís74Ä4Xùí\©U°á‹ÐC°ø¨»‰œvÙòZwXƒ$=6Ì! èzŽ»¹~“Ì%´µhç×)îs74GîÖBÓÉ,ñ*ô,~‡»¡}˜¦F¦óxÃairŠï¡‡`ñQw£Y ~åÖH$¹ “¥Eñh®’ÞSµõøðÐsî˜ü:Å}‰Íµ ëÇå|vŠï¡‡`ñ;Ü ís7<¡Ü„Šâ?dòF]„žE~ÖÝq/ŠÙ¥äŽð^¨a§p‰—ÏÏšïD^ì%ž\Y*öXªFå}î†oBéô¶0Õç¹þUèXäïp7¼ÏÝðMÈÀ`©^b/™l(Z…‚ÅGî&¾tµ ÄŒüöS)&¼Š»¡Žk˜a‡“Ë‹=ZMï­A¨Ô%u§ÁûÜ ß„ŒF×à¬FD³¼¸=‹ßánxŸ»á›Áð,€6áQ¡‡`ñ‘»‰²ºT¸âc‡bMzøGþodðŽê¥­GóŸbTµ×€Y”ÇÔs÷‹¼ÏÝð„Š¢·¡¬QONñ=ô,~‡»á}î†oBã}×ú/×åäßCÁâ#wõ ›FkÔÁ &wÛ`ù"ÄÚòs!’ñð/pttáËh}¹ç×)îs7<™ª*å¢<}£¾‡‚Åïp7¼ÏÝðXümT1i #ÑYuózŸ¹ƈ†µø•a šÜmS°ž¦\R?Kª2»mŠ´ÒÙ%ʈj™}÷ç½wŠƒä­“™ŸOñ=ô,~‡»á}îFnB†MPc™õó).BÏÀ¢w#|·0ž'#2}£¾‡‚Åïp7²Ï݈ŒdÇæzÅÍÓäßCÁâãÌ”)ulB•hÚ|íÆöW^¬-ú½Ö ¼2Ô³;ßz|tð–ø_3{‰ïÏ{ïÇò¨®õò\ˆšxöF}=‹ßándŸ»‘›¢ë_‰É)¾‡‚ÅÇ™)+LQ-˜FãWÉ“y1JL,EÓg”΋¨OÍPÓF³ùë÷¹&6úR(ªOâÙ)¾‡‚Åïp7²ÏÝÈŸåQ?>ÒJ•fÕÍ{è!X|œ™BQ ‡ lPLî_üÉ‹E,E¨æöÿüpƒÙZ!8®§°¸Ï݈‹ ¦q±æ³~ñ=ô,~‡»‘}îF‡˜†°]°j¿¸ÇS\„žE}œ™b\´KüÎÑ$Õl¿D± £»qêNãç‡ Þ¨pkjGøýyïâ0±¡­CT-:Û¢¹ =‹úîF÷¹ƒPñú¶N%*ª™ªxzŸg¦X‹G^ºþ œÒ†#µ•H‹ J 1› ÎéuŸçšÂâ>w£cªZİΜ5¡‡`ñ;Üîs7z2‘ãZE%Wûd+Ê*ô,>ï™’J¦½+¬ýÿÈýbÁä£ÀïøÿÀýbtd0¾úYRµÅ}îF!S/‡+ìÇœñ¨‹ÐC°øîF÷¹µ0qW)S&ê©Eè!X|änÄ(¾s†cMEªF…ox!3TòäœF¤Ÿ¨o[ª„Ö‹Tâ>w£cy(G9L-À69Å÷ÐC°øîF÷¹íwÉbQÁµÈ¨QJMüQ¡‡`ñ‘»‰êv5ÔŒ¢*³¤•£Éd¬€‰æJ ãøç‡±< C—šë×}îF‡‰MNk½G¦Ù)¾‡‚Åïp7ºÏÝØMÈh댆>^•3õÔ"ô ,Ú#w%)·&X‚Ø<åUüŸ¢¨®ñ'îì©Å8לVÆvlóè c™mŸ»±{yTq‰³)W©îfzí;Üís76Ä4† )½´™oø"ô,>s7T+lÙJ”©É}Q]Z¼|(RH4œÉ}X õ`´gX¸4ËùuŠûÜA(oX¹ªVÔ'ÜÍ"ô,~‡»±}îÆnB¶1±M5¡‡`qâwc¬]#`ÛwÂnøšëj®šVøPº%ýn¶PteyxÊcÃö¹„ ÇÑÔJŽù®É)¾‡‚Åïp7¶ÏÝØ„Š‚…£ ë³i›Eè!X|œ™ª,M{4Fp=³ä>f(È+îij;Â[$ãh7[·…r./îs7v‹i ¬'É< êÙ,ñ"ô,~‡»±}îÆÆ T´D0Y*]gm¡‡`ñqf ìiŸY*¹—8RöWc†ÛF6/ Òüg®ßsXÜçnì&dÜ#ûVÃåiuóz¿ÃÝØ>wÓþˆiŠYÅÖ)“~qzÛãÌTUuê°GlÌæÅøÎbª7| Ù¼åiüÿµ&Mí_lûÜMÄñ¬Èt­±O°¸=‹í;ÜMÛçnÚ!ƒÁ<È„ÑGÌ6-BÁâãÌTÕ,y7IÊ«8R›0<¶[ †7ɼ(Áø` I ‹ûÜM‹¿ãp`̱ýÉ-ñ"ô,~‡»iûÜM» ™¨;»°•æÅ'ýâ"ô,>ën.ƒR¯Q[Çw0aýý“ƒØ†QñÓÉ=S U );61¦°¸ÏÝ´AÈÀø„+¹éÌnz¿ÃÝ´}î¦ bÜöøªê¤ë_„‚ÅGÝMÔ¨ØÉefômœÂb¤6¸ú"MERTNî_ŒÕJÅÂ’ñ÷¹›v2½Á~ Ä¯ZgS¨‹ÐC°øî¦ís7m BuöLŠarŠï¡‡`ñQwƒ5xâ%*kS.‰–ïÇUJ¤EDå”÷GŦ9vÂ?¤ä°¸ÏÝ4ÿSxZ¿ü@Ú´ºy=‹ßánÚ>wÓË0”*C)°îfzû³î¦g-[t}5C…^º"üy¯ËñJ âçÒÝÐÕiz³jŠ»éûÜM„ —Þ¼õ^¢˜œâ{èXìßánú>wÓo1M4€½•Ò ž¼“S|=‹º›Þªµ"‘ÊKcÊú†c‘F¤Ô(Îq]”Ì‹ñ~Óàfaë¥Æ¿NqŸ»é7!¥§×\<áQ¡‡`ñ;ÜMßçnúX…6^öâÌ&ß¡‡`ñQw£Q^rüåÊ"ÙùEÞ˜ñê©Þµ$ûÅè©£œ— ¯çö÷}î¦B&Þ­´¯“uz¿ÃÝô}î¦B¦ÇNûFÚ'Ó6‹ÐC°ø¨» xáhÛÎYɼèÑñU¬ÄðZ)=§Y§EV-ÑþIIÍLõ}î¦ß„Œz8Þr7ÕeU±Ê­Ïú†®%%*: L¦<¯ŽN³Ãª˜“^žÏÝøXüiüAaÌ?ãQ¡‡`ñ;Üïs7> ˆ=¾q wlŸ¹-BÁâ#wÓ,Z6ñVqGØ“{‰#­E»IX1Ëžö‹"PðÞrªæKÓñ_§¸ÏÝøMÈ ®(>£òœañ=ô,~‡»ñ}îÆoB¦y|Y‹‹YüÇäßCÁâ3wcÛHC Œ$sy1ÚÌV¸·Zã?²>pXýë«X»H‹ûÜßbƲWi‚bV£¾‡‚Åïp7¾ÍÝDr›ØÀÂ*ûd~qzõ¿–È‹®ÕŒÑ#á†0;ì "…PÍîÓ`‹—V1ïÅÍ2»mîÏ{u"WT&<ê*ôÿ$,^?÷ÿýÿö?þßð¿þÏÿõùßþêÿïÿõÿüŸÿãÿÿþ|Œõ ÌFi"ñRÃfúûðÿøŸÿËÿþ?ñ?õ¿ýÿñÿù¿c{ÿšàûi°ÿŸyJÿõ•Ä÷gó+Ñ­)á5)ÜÕ¿¿’ËÐ^,×wêáűLc"ê±¥—ƒD91þ̸’J¼X¸£(‡$0BNš W7—Ëä&Òk²FÅäjí˜=‹r51Œ9>ï½SŽ<%Š•*÷¾Yúz¿ÃÝÔ}î¦þqä)Œ4þszŠï¡‡`ñ‘»!)ÚËE«HÊ`rü‰##zuöl^”â•¢@øŽç°¸ÏÝÔ± +Þ’$dݪΪ›÷ÐC°øî¦îs74™hj¢ˆS8º<Šˆ–¡g`‘¹V¸¸ÕÞ¯—4ïÁ¼˜üZ¯[œD^d¥È‡0¦ìÑ›-ßÿ>EÚçnhLui%va£ô„G]„žEúwCûÜ ©.bª­zñÙäßCÁâ#w#êäèØTÑ»%ó"ãøC#Áy•Ü)Æ“ãÇ)^Uxm¿þë÷¹S]q4lõ°õ w³=‹ßánhŸ»¡AÈ´¦µc¯óãÐÉ2ô,>/ëåÞ¿³Qà"µÛ X±6+ú*ášìás½º ê]Û¯ÿ:Å}î†!cX)¸Òì~qz¿ÃÝÐ>wCƒa½ÜºP™p7‹ÐC°øh¼l0Ъդr§žíR1ç€qtœœ¼ÓPn¾?ÅjI,YŸ÷Þ)1 ÆòZë$,“~qz¿ÃÝÐ>wC7!EX…`˜ÍŸÍ{–¡‡`ñyáy$4Áfš¨ÌR>æ?C'½‚Hì(žÓÝ\Odž ŒsfŒÏ{rþ¤·<Û„.CÁâw¸Úçnø&dâÛÆT0 çÏK–—¡g`‘¸›òVå€j‚,Us‹]!c‹z<š=lyÿOœbÎL9¶@2Ú½øå×–«åÅ«ŒµË9¤åò¢ÇaÀœ2>«H¬‰…ãóÞ;Å!¦©J­Že¢*^„‚Åïp7¼ÏÝð dœ«ÖHñ™añ=ô,>ênÜz7¼7ÜÙ¼ˆ¡m‘Ý"¹åN?r]ƶHCžÒ£ò>wÃÑ8…ˆMOñ=ô,~‡»á}î†oB†¥IeŽZª=› /CÁâ³î¦H ,bнp_ZËý•+uèàD"±æ4pדkÁ]ˆ{i”0 Ÿ÷Þ)B&ž¡´Z-îfz¿ÃÝð>wÃCLÓàVgâµ>›Ú-CÁâóÌTq2lnEjÂóãʋŴt;ñ Öd¿ˆ';>.ï•ËÒ…ë×)îs7<¶˜ã"^.0¬›œâ{è!XüwÃûÜ 1ÍÕþaÜvòF]„žEyž™BƒÛÌàûݯ[¾L^¼¦qCÙP—'ób<¹+Ö§ 5aÞ3>ï½SƒPĽÌÜ OjÔEèX”ïp7²ÏÝÈMÈDÆ0pŒíÌNñ=ô,>ênà\a:Ó­ü,IäÅ€ vÀ(×2É” ºÇGŸclZ_n3øuŠûÜüqS†D `¯åyQÏ2ô,~‡»‘}îFd\Æ·…¢n™uý‹ÐC°ø¼ð<23“îÞpº–f¡]Äp?«JLþ<¹U^ÓMÖN±¿NqŸ»‘AÈ`KžRü£Cœâ{è!Xüw#ûÜ 12;µ‰”I¿¸=‹Ï Ï)¾z—YVåVRÜ ¶üxü½0$c=»$žìrëÒiùøuŠûÜ B¦šc÷A­TfoÔ÷ÐC°øîFö¹¹ *®Â& ›É)¾‡‚Åç…ç|y‘3ìà´¤¸›ÿü5&VôD¡ æñgÊ‘\SXÜçndˆi¬ö†+”.“S|=‹ßándŸ»ÑAÈDû`ñi¤:Ql,BÏÀ¢>ên*+VIª[Bq¹FXãÇÑ÷ {­),þ8¨ãMÐËµÕ ƒEÝçnt B ÜN[‰‚\&5ê"ô ,êw¸Ýçntˆi¢khÖŠi›Õ¨‹ÐC°ø¨»‰Ê´77"@p¢ÌD^l-ŠS©¥Eë§=Û/FÚ©®Á€¬Ôâ>w£7!£¤„Ý-FmúF}=‹ßántŸ»Q"S¼ ©v7Üõ/BÁâ£î¦FFkZ 1³›§Ø®tX°yÑœ³<*,e¢,–Þ4>Á÷¹„Œ¨5CÒS›â{è!Xüw£ûÜÞ„LÖADÑGL±øzŸu7bÕšŠ¿'ó"¬ÜÄ4Ú«V5QàòýdïNbÈB)îF÷¹[Ì£¡íMŠGE<«QßCÁâw¸Ýçnt B5ë¸n4¹™Z„‚ÅgÝPüÚø{¤„\^„ßxïð5á’Zxþódë|ÍC”uuüë÷¹½ ‰¿] Þ–“S|=‹ßántŸ»±2šÀ.­WޝOf‰¡g`Ñžu7RÆM.º^uü;/Zä4%,Ç%ev™d<¹Ã;mÙúfóß§hûÜ B&þx0¬«ñþ˜T7‹Ð3°hßánlŸ»±AÈtSL%öZûD·=‹Ïº!¢¸ Å$Ù/ZíÑ»a‰y]ËØþ΋5PØHrw¶ÏÝØ„*ìJxÔßCÁâw¸Ûçnìqqƒö¹èÌcczŸu7RHãíɑ͓yQ¯éG2LöKn±ëÏ“1E\Zß)pâ>wcc‹9aá®’©³7ê{è!XüwcûÜA¨J‘4Jæ™nzŸu7W€1ˆE±šÒ†cWa¼sDA<Â/Í£âÚÀK­ ÆU,îs76Ä4´:só[„‚Åïp7¶ÏÝØMÈ”V1„ÉÒÙ-ñ"ô,>ën¤Öø…#— Œ%’yQHÔìÚ[Þ@¾ûŪÕ­´¢5ÅÝØ>wccyžUÍO‹ÐC°øîÆö¹›v2‚a8Ø4õÉ).BÏÀb›èn\T#/V…÷L2/F‰©ØJܘ«äó¢xdE* Ë‘3XlûÜM« ÏR¢Z‰ÏÜß¡g`±}‡»iûÜM„ŒD±‚^ön“S|=‹ÝMüÔ Ûx¢ÏMæÅwÆÖ8ѵtæoÝ Ìz‰O %a ‹ûÜMƒPÜÈã±I¿¸=‹ßánÚ>wÓ!¯a|ßâo2ÑÀ-BÁâDw£ñ½“ÂXsfɹ~‰·Ot‹ äOªÀ½w¡–ø˜ˆ;‹K./îs7M‡È”#}·Þ»ŸOñ=ô,~‡»iûÜM» ³ÎÊXˆ4½_\„‚Åéž)WÁ\›%õ¨‘ EøZ‰î”×£b7x£׫ššëoûÜMË£ZÔœ}K™v`ñ;ÜMÛçnÚ„2Üù¬îg¸Eè!XœìZ¡^«º-É£ ·jµÃûNZIià~žÜTã ß¹¬ø×)îs7í&d4 võóñÐY^|=‹ßánÚ>wÓ‡˜¦Y7†™ç´ÓX„žÅþ¬»¡æÍŰáF,9×qŠrvNüÙ~ÓRÜp·Ï_¾þ}Š}Ÿ»éÄ4}`ï͵Möi,BÏÀbÿwÓ÷¹›þÇ€ã+3¯âEè!X|ÖÝ :äá8á£ÉtøøSäÆZSw?Otœ5þg]àþ:Å}î¦ß„ $¨‡»ô:©Q¡‡`ñ;ÜMßçnº a›36>´ÚfŠEè!XœøÝh~#[O.ý΋D…D¢¿ÒšÕ£BS}AóiD‹ûÜM¿ u‹ÿ‚N^eÒi,BÁâw¸›¾ÏÝôabSÕ¢ÔZØ&7S‹ÐC°8ñ»¡k ¯Öøî­ÙÌ¿ò¢©s3¸«Öš¹áûÉæXãÁFë«_§¸ÏÝô›ñèK[©¥ÅM¦m¡‡`ñ;ÜMßçnú„Ùo/JÝi,BÁâ³î†jTˆÒXš±&çY¥`Ï]ÔYÝM<Ù±ŠµÃu-5§Ñ÷¹›î·$ÊZGåX¯89Å÷ÐC°øî¦ïs7>™h§â;ÇL?ÖØ§¸=‹þ¬»Á6¥¦‘™”«&ç4Û©¼TÇr›–ö‹GK‹»õžó ÷}îÆ‡q“8“^°d‚ÅEèXôïp7¾ÏÝøMÈTÓ8©ŠM:Eè!X|ÖÝÀ(Ø›‘›”Ìhþ•¥6·ÅÏe.D~ò"Ujb¼Šû÷¹bhØ#ý6žnbX„‚Åïp7¾Ïݸüi[3LÓì®zŸu7¨…¢ª6çžåQ)~³ÈÜ3Íæí®¥röþ¤xTßçn|˜Ø\‡élŸm(Z„‚Åïp7¾ÏÝøÓt-W)÷Ù´Í"ô,>ënª[ÃÜ%SŽ»‰¼Y7Áñ>ÅÙûÅ ™ym°ðÏåÅ}îÆÛÝ”‰ ëf¸Eè!XüwãûÜß„ŒlɈ÷øL=µ=‹Ïº›(¨[+Ú*ƒ­ÈåE ù5(è0ÿ”ÃâõdÃÄ”’è ûë÷¹ÿ³ø»:îAá$=«QßCÁâw¸ßænjƒPQGY·êÅ&ê©UèX¬ÿý³üÉ‹TÀ£6Ö’zTê @©ˆDQõ ';KƒÑF[»AþëïÏ{Æ+6’+œÎŸ±¸ =‹ñK~‹÷ç½wŠƒqõHt dêóÍÔ*ô,NöL•늯!A­·=ý•¼5Z6 góbñÊQ¨þ°¸),ns7µÜ„ /"ÿK…ÔgrŠï¡‡`ñ3ÜÍýyïâX_™¨áàÁ³7ê{è!X|ÖÝ”fR8’£Ák#™5pè]‰+n“y1ž KØíD«šÂâ6wÇq2Ð`ŠÒ‚É)¾‡‚ÅÏp7÷ç½wŠÃĦh~Ô+J¸Uè!X|Ö݃øÒ¢Î,Ô’ûI«Ç Üà¢ÐMæÅÅ bÛaµ ݯSÜænð·°-^æîÆÕfyñ=ô,~†»¹?ï½S¼ ™J;GG>ˋ`ñYw1;EzÝ‹&u7?Ϊ®'÷Ì…ßOnðI®5¾ù¿›ûóÞ;Åa@ŒVNØF>qœ^…‚ÅÏp7÷ç½uŠu,âˠϵMª›EèX¬Ïº›B…ªÂÝ¥F&HæEò+…`#³SvN#žŒ:ͼðz#ò¿O±îs7µŽ¡Äë,ê<É‹‹Ð3°X¿ÃÝÔ}î¦Þ„Œ\÷÷¸®“M «ÐC°ø¨» ¬{ÃÕ¶_ŽÁ“ãyÌ‹©ôËz¼VMö‹º’ÅQLðå=õúä_§¸ÏÝÔa@,QpšFol“ùÅUè!XüwS÷¹›:¡„`ÿi=ª—Iu³=‹ºGÏUµk¤ók–x‹‘q;é‘@¬ôîI¿›x2®'‘V%JÜ÷¹›z2ŽÍ 2ãQ¡‡`ñ;ÜMÝçnêMȨÖÈxÎ-:¢gÝÍ*ô,>ên¼–CýrKJ3y±ö ¶J˜¾Mí¶¹žh,H‰ÿXfä_§¸ÏÝÔ?‹¿çc°Yuóz¿ÃÝÔ}A(2ÌE1eࡇ`ñQwãfrI¨ÍÕ¨ñ'v8¸Æ‘£ñËæE³ŽV±´úµŒc‹ûÜM½ x”G3ïÅ{V¯BÁâw¸›ºÏÝÐÓ”8›îªŽ=L§¸=‹ô¨» D0/K2/Öî$8ÞÀæ4É£bÒ»Éá»&uùäŸ"ís7TÀpJ¥»ÌÔS‹Ð3°HßánhŸ»¡AÈF‡Å˜:롇`ñQwãñòèͶ™öfɼØÇ—ž´`÷[6/FAÕ ìeÙ©þ:Å}î†þËÄæâˆ¬Èì–xz¿ÃÝÐ>wCƒ©-Àe¯½½Ï§øzu7Žß– fl­Û’Aù+/¶(N ¢¢ZÍæÅèÌJ¡Æñ&ðå[à×)îs74–GyüŽ5^‘Úʬºy=‹ßánhŸ»!»_“¬j\,@Ÿç4V¡‡`ñQwã¨O{WeÇT2/š>§ð:.Ù~1ʈ€°Uަ±¥xTÚçnh2Ü ®* ‚»É)¾‡‚Åïp7´ÏÝÐ0 î=аøÒ‘ôYúzu7`3õrv‰UÒy±v(Å—ãÙ}‘ ¡hјaz2…Å}î†Æò(¿V¯Æ¶ÍTÅ‹ÐC°øî†ö¹.ÃþÄ ¥4Þá“7ê"ô ,òDw㑨úØŒ3×õ?y‘H¬K皻Ӹž\¯;G×"ÿ>EÞçnx BIœMëhO}Òi,BÏÀ"‡»á}î†é.Y.’PKNañ=ô,>ûÝÄoïÜ"Çw0#c»ó"E5µÁ&«G­Â5’A¬”ñd¼?ï½SƒPp~”âEiŠÅ÷ÐC°øî†÷¹¾ ™5\×եϰøzŸýnâ÷gÅÞ7èRS;ßâ‡M…¼UtÉšÕÝàÉq­¹5!òë÷¹þ3í)i€º‚çS|=‹ßánxŸ»á[LC× X¼¿ÛžOñ=ô,>ûÝÀÀßܬÆÿ&IßðHÿ “PÎ¥ç a·t?ä™ý‹÷ç½wŠcªAú®ñÞ¡‰‡ÿ*ô,~‡»á}î†Ç T‡J¢øŒRnrŠï¡‡`ñYwÓ{·ÂÅâõ°Hò¨/ŸÚ£$w²¬?ªGíP[1ò^¬” wÃûÜ ר†¥Itô³êæ=ô,~‡»á}îFn1 ^‘SPqJõÔ"ô ,ʳî%ud&-ªÚSw‘Ú>—»jIÎãÉÎŒEUñ›•*ûÜ âSæŸô‹‹Ð3°(ßándŸ»‘?bšHu]«Gÿ0Ql,BÁâ³îF°?‚¨q‘èÞ’yQþQÄPÅç¼§ðäNH‹Í£9«)m¸ìs72 ˆãö'.·«ÐC°øîFö¹Ä´«E:©n¡‡`ñYwÃµà–¿ÐEá$ó"®éáp¤–ò*¾ž,—U±°°æ°¸ÏÝÈÓ´(Æ…›ÃšgrŠï¡‡`ñ;Üìs7r25Zª(Â0›LÛ,BÁâ³î†#'uQÓøî­§ÿÊ‹l‘r1N™«òÏ“²;“~{2îcqŸ»‘ÿ2 ÖèKTãþì¾ =‹ßándŸ»‘›ÁÒ\W%†Ïg§øzŸu7µ±ƒC:³PvNƒÁÂVŠW\oé9 °$ñYYOKRzTÙçnÄÿ$;[¤³Y^|=‹ßándŸ»Ñ2ÈÑjŽaﮓma«Ð3°¨º4kpÓx•¤jÔ‚ã5~°$“ì^âxr7E wÆw£ûÜ1MÓµ7qŒMNNñ=ô ,êw¸Ýçnô&djáÎø²Ú„[„‚Åg¿›Ò£J… ‡ãE2/bë"1îã”íK 7Rceúq½ÚÇâ>w£|¿&#óĉÑ×NºþEè!Xüw£ûÜʸ¨h¸ïp«/“S|=‹Ï~7ñ•#¯T06ÅÙ9Úâ+ÛIá7¼¶þ+/èè/š$:ÖT¿¨ûÜÞ„LŠ;vTÍ4p‹ÐC°øîF÷¹‹¿µ3¾0°¹žÕ¨ï¡‡`ñQwƒ)‰z¬A¦]—7îåEÌ{”¶Ú893…'ã 6ù²:þuŠûÜÞ„L4¥N·4Ýõ/BÁâw¸Ýçnt BE%%V¯ïëD·=‹º›î…ÒKë’î VkQÁfÓd¿OÖKŠJàrSÜîs7úgy³àò X'§øz¿ÃÝè>wcÿEÈ c-m²EszíQwÓ±9B<\øSžŒ” 7Üä`k¨¦<6®' ¼d R— mŸ»±›‘fûç©?ê"ô ,Úw¸Ûçnì&dJgxñÚµirŠï¡‡`ñQw1)!3FY.› ãÏߣN:3™¡díB¢éÔjûÜÝb5³r±Üm6׿=‹ßánlŸ»±!¦‰RÅ5¾2€ÚäßCÁâ£îÂðèÛH”¸g}à0|X4~òÌóÏ“£¤ËK÷\jûÜ âx˜w¦Èã:«nÞCÁâw¸Ûçnl,âB°u·&4¹%^„‚ÅGÝM7îÞ-RT±x‰äò¢³À¼ßU •Œ°üÊ‹†e:ñäÖà Ââ>wc÷ Ô5w!ÆQxꬺy=‹ßánlŸ»±›)kíG¤:ë4ÞCÁâ£î¦ëURfË­¿óbwXœ¶h6]%‡ÅëÉ]pׯ굤îmŸ»±›¹¶)²I‹¤7án¡‡`ñ;Üís7í&d±T¿8 ›äÅEèXlº¸~[@‚j‹ —œ_ìZ<Ò¨›H' óÏ“ÛåóY™Ötÿ>ŶÏÝ´!¦±îѶ¢]&yqzÛw¸›¶ÏÝ´?‹¿ãõHÝaW6qgX„‚ÅGÝ æ–âý_ãERZVm¢KÔš%0ea9ÿ<™j<Ó«J[« ~â>wÓÆò(‡æ®Dç2Ãâ{è!XüwÓö¹›v2¨YP{ŽÉ)¾‡‚ÅGÝMÇÊ7DzîÿJî™ê˜h0ñæ‚e0ɼ¥qkjÝ™åöi´}î¦ !ÆÍ/]goÔ÷ÐC°øî¦ís7í&d "­J½N±øzŸu7"/D†KÂ’í1þΊUäšÍ‹æ ·±^â–ºÓhûÜM» ·k *Jâ6͋`ñ;ÜMÛçnÚMȈj°HuÄ Ü"ô,>ënXkñ¦ÑKsò~±óå•ãŽkú导ÈJ˜¡çÖ(9KÜö¹›æ’«Dw«<ÛŠ²=‹ßánÚ>wÓ‡‰†‚Z  Mòâ"ô ,ögÝ ,J³z•«&õ¨P“GRƒ_±ÕL{åEø1:VqÔ(qS{‰û>wÓoB¦Aþ^£G…ÏÛäßCÏÀbÿwÓ÷¹›>Ä4VšEcÓk£I^\„‚Ågݘ¼bx‰êZýòw¿hÑ( \2/jÉUæÀ¹»þ¾ÏÝôabƒ%<Öà87sgX„‚Åïp7}Ÿ»é7!ÃÆª±”È{“S|=‹ÏºØœsQ(ÒšeóbSÕÌ£çTO~î5ÚTëøñ¤î¦ïs7ý&d¬ 7)+ÝÍ"ô,~‡»éûÜMĬ-:¢V¢x™Üõ/BÁâ³î¬‹z´Š‹ÜÌTù'nñHªÜ8¥»ž\=ÞYæ/±”î¦ïs7ý&d„¡£1èQ¡‡`ñ;ÜMßçnú„ŠNJ⿉[åÅ÷ÐC°ø¬»Á2Òë>mcS÷ï¼ØPÈáB®Ç>™E¨F£Ù1>Ϲ¼¸ÏÝôabg£ÑÅÇŸvæw³=‹ßánú>wã7!à {$êZ']ÿ"ô ,ú³îF¤’;´, NæE jv,ׯ'“0&<8êÛwãûÜA¨nÒ ,&5ê"ô ,úw¸ßçn|2íT€Ø@vONñ=ô,>ën0­ç&†+Jí¼ÈÀ…G^ä^8{¿(­±b|2JûÜ^bßçn|,þŽ6ðÚm“i›Eè!XüwãûÜBSzµX‹~~†Å÷ÐC°ø¬»1 Z´Új4¹”äQ£+v¯m¯/gL~æ4*iô£R´.›Í_§¸ÏÝøMÈTºÖF¹Í&¡‡`ñ;Üïs7>¡Ša¢ +Fí&§øzŸu7ì†F€‚×Nú¿ó"ôÓøã{dÔÿ÷‹Ž7ŠÁn¾Þˆüë÷¹‹¿ +?:Dì3ßðEè!XüwãûÜBâék Ïf¦¡‡`ñYw#؇µuqUNiàÊ?ñæ!"@M±Œ9Û/º”@0>ÚºSýuŠûÜA¨îŽóé½Ì<6¡‡`ñ;Üos7T†‰2I´EMêÄYszé¿–?÷‹ŒaÞŽ‘©âÉûE‹ty6c丛ëÉ04Æ–©QïÏ{ïëÝÊ£oˆêS1R29Å÷Ð#°¿äW°xÞ{§HCØ&qø° ˆwåäßCÁâDwp*Í1íë)¿ò"RTÅ–pc[—™ß/Z Rƒ™lYù×)ns7T†˜Æ0]ê—FhöF}=‹ŸánîÏ{ïoBF‹ððÔ¨âžÕS«ÐC°8ÑÝÀ«ž8ò¤{¹¼ˆÝâj„p¤×´îî¨5’+ÕTzÞ{§¨£}ˆ_^Ò•d–ßCÁâg¸›ûóÞ;Å›ÁMETžÖ³7ê{è!Xœènà–ÅÖâ‹×rÚðòZ¡À¢8Öjd’*ßOŽ^#ŒÑpft7÷ç½wŠƒ‰Î4þÞú„ _…‚ÅÏp7÷ç½wŠc K1¹ªGÝò<ù¶ =‹ÏºŽ`P ·žì•‘M{ã*¹™©Ÿ'#%žÛƶ¹_§¸ÍÝPñ›âŽ>V Òu┲ =‹ŸánîÏ{ëk²}G7ͼù¤_\„žÅú¬»i‘Ö*có@n–8ò"s4WBÒQÐeýnšiu6¬MÕ¨uŸ»©·˜F› ¢¶FZ&5ê"ô ,Öïp7uŸ»©cy”Õß—+ywSo1 c•[ô€ÝóÂz¿ÃÝÔ}î¦þ„êñ=N^“S|=‹ºØF)E5vÝ0$ûÅ‘GN…T3¹¼ˆ'ËÕa“”ÔŽðûóÞ;ű<ª´j]Ûe99Å÷ÐC°øî¦îs7u/ÔkuÒÉ.ÔUè!X|ÖÝ·è"%Æï-ÉûE¸†ÇŸ6¾º•$çÉøóäHÈP´yKí¿?ï½SücbáûUONñ=ô,~‡»©ûÜ Ý„Œk$9¾6†Îª›EèX¤gÝMñxAÅ‚­'g‰#/BÕ ñªÁeûÅø1´fEj·JûÜ ¡ÆÑÚšºM:EèX¤ïp7´ÏÝݯÉxm« Wš¹Ü®BÁâ³î¦XqÆ^#)î&ò"ÖLut}ñã1+ßOÆ#æ;Å÷ÐC°øî†ö¹ƒPÞÌJ'³~ñ=ô,>ênî3šzŒÖ=éNÞëL Ó~¹õz²‰+\ü=ŸÂâ>wCcÊ. º Æ¡&§øz¿ÃÝÐ>wÃÀøÚëÖ»ÎØðEèXäGÝu Z4(¿JÒï†L¥Xô{ðÈúÀ†¦®!dxÐ¥¸Þçn¸ãŒøM‹–æwrŠï¡g`‘¿ÃÝð>w÷˜†C¥¥Õ¢<É‹‹ÐC°ø¨»‰÷èDÉ µ 5ò¢´ßZØû¨etüóä¨l)^[ÖjjÏÔýyïâ dèÚU15éú¡‡`ñ;Ü ïs7ên ÛH[…Ë…™&ç‰8^=Q™7çHpÙ¼è—\‡â‹”Ââ>w÷˜&°¨[àê>ˋ`ñ;Ü ïs7|2Üì?É<ʱÉ)¾‡‚ÅGÝÁ|Š"—G~,=q-qåÅêµÃÈ‹qÖ6ü÷‹Ü™q¹©59§ÁûÜ ß„Œ\gm¼jÜi,BÁâw¸ÞçndÅë›+Êž5W¡g`Qu7¿²1®£T]«BÿʋűYn°%½—Øâ™"5rª¬ÜŸ¢ìs7r›ØÄ#Z”ââe:§±=‹òîFö¹¡!‰º¼±£¡/2Ãâ{è!X|Ôݘ÷ÀÁ ÒTÒ•¢;–¨PI°“)›=>%÷È?Ñmö”îFö¹Ä„í;ðÊ,eÒi,BÁâw¸Ùçnd˜Ø4x,FþˆÆh†Å÷ÐC°ø¬»)µ»b¹0÷¤o8UÃ|¿3æªüóä(p{|õãS[; ü:Å}îFÆ ck”hÕ3Eè!Xüw#ûÜØ¡‰æÁ°>JxÒi,BÁâ³î¦pÔ˜­qt‹V“sgn^k¤Æ¬ßM<9žY Wu-øuŠûÜŒÅßø5]®5§3,¾‡‚Åïp7²ÏÝÈŸåQÂ*DÉd+Ê*ô,>ën¿táÈæX¬”åQ)*L‘H‹Ê™+þyrÔµÆTûXSXÜçndˆi4ò\)ÖŒ&[4W¡‡`ñ;Üìs7:Ä4-LYJ™åÅEèXÔGÝM‹j¬ÁLû42òîŸûE6ÅJté)2›£)óx;F‘\8Õ/ê>w£cª£±Åp/“Nczõ;Üîs7: ˆ1¤etß“›©Eè!X|ÔÝ´ÊïêÝš§ï­(hãè”SW?zTÂÞFlè†Êà×)îs7Êwûõ¦÷KU0›_„‚Åïp7ºÏÝè dÈ9º‡è«¢­šœâ{è!X|ÔÝ´KŠ L©Iià"/ÆO–ZjôWͲ÷‹ñdµÅ`¯ñì”U÷¹½ ™F‘í°³òl~qz¿ÃÝè>w£6ßÑ1Ö€í{>Å÷ÐC°øìw#¸Iƒq·Qõä^b¢ÞD!àŒòvm“ñW^”ps¤ˆ9È÷¹‹¿ QTÚ}ÂÝ,BÁâw¸Ýçntˆi À0¨iâý?9Å÷ÐC°ø¨»‰¤ˆ½¥ÆßkN‡~±Cyk*VZvŸÒqÔ¶‚ÉkJí|»?ï½S&6hŠ3Ež½QßCÁâw¸Ýçn¬ŒKÃîFEŠ—Ù´Í"ô ,Ú£îö¤ –®¬‘’~7‘ТšsìD/\³ý¢Dʬñ ‹o} ‹¶ÏÝØ„b0EÒq:;Å÷Ð3°hßánlŸ»±›‰—~/¿ò¤ë_„‚ÅGÝMƒëw4Šf]{Íö‹°ÿWMVgûEb¬á¨65KlûÜÝbšx--røLɸ=‹ßánlŸ»±›é%*φÑÑNNñ=ô,Nt7Ú+ê{ƒþ2;¿ˆù÷èªJ‰*7ëZÔzMêQmŸ»±?ÄZ¬qS8ÖMNñ=ô,~‡»±}îÆ!ãµ·ÈVâ ;9Å÷ÐC°ø¨»A:¼¼n$Óy±D>B™1=×ßo/&ïë«_§¸ÏÝØ0±Á,[z:úÛI׿=‹ßánlŸ»±AÈH仨ã°Z~Öi¼‡‚ÅGݹ`ï"ÕÚ«sV,‚á|X¹%óbwcƒ1·^UÈm¶‰az¿ÃÝØ>wÓ†˜&^ÃHtÑM6½¯BÏÀb›ènJ@°u‚G^fmÛZ½+‰XäÔìœFÃ:dU»VÉäv¾µ}î¦Ý„ ×Òã)-p6ód\„žÅöî¦ís7í&dÐÍÄûßã=>Sl,BÁâ³ßMÔÔ\¢P-‘ ²û4IÁ„Âm¸e.DøçɆÑÅ.ðOùÝ´}î¦ý2†ûÏèN k£g§øz¿ÃÝ´}î¦Ý„Lƒ¼Kðuí3nzŸýn°U‰Uô…&ûŪ]½Ãq\¬µìü"7‡¤\1ÚŸÌ‹ûÜM» ™(…-rx”F“Ncz¿ÃÝ´}î¦Ý„L ¦Z›o´]„‚Åg¿‰VO%ú#‡Sv2/rƒÏ=s©”DæŸ'×h¬#÷ôRÖÿNqŸ»icyT¼q÷(©…&<ê"ô,~‡»iûÜMë÷Õ/R”—:U2.BÁâÌï&¾v5êD†…]2/Rü‘5:+€*ct|ûÝD‡Ú —¾¼îTâ>wÓîÅßYWZñgMÛ,BÁâw¸›¶ÏÝô2$QØØ‹]|ÐN?žâ"ô ,ö‰î&~ý¨•½”ÌØÓ•É4~”Ø¡ÝIÍL]O®Ü¥aÁQjŸFßçnz¶`µ1Ü#£üœ`qzûw¸›¾ÏÝô›©=¾¨’4RÞäßCÁâ³î¦ lŠ]k«š±þÉ‹°FêV¨ôìý"Æk±Ò‹Äç–Ê‹}Ÿ»é·˜ÆâM †ko³7ê{è!XüwÓ÷¹›~2˜–ªS¸€*|>Å÷ÐC°ø¬»‰¢Ú£­zOÎõÃÎ-"9&w¾]OÆü²I1Å}‹ûÜM„Œô=mÁ£&ÜÍ"ô,~‡»éûÜMÄÛè§”›œâ{è!X|ÔÝô XñC”šåQ+Ât8å=…'W7#wÆènŠGíûÜM¿Å4„5q*î^f5ê{è!XüwÓ÷¹›>Ä4.D¢(Ÿuý‹ÐC°øìwc†)¢¶²vcû!êÆø"Eräk…âäxžó¢Áÿ°I§¨"Rº›¾ÏÝô!¦Á®*ñÛFE>9Å÷ÐC°øî¦ïs7~‹iı—¥ÉDɸ=‹þ¬»éî}5Ž&7cE—t†X{W¸ÝÔK·ÅëÉC6îHNÍiø>wã·˜&úRW\¿4ðDϧøzý;Üïs7~2‰˜iñ:©Q¡‡`ñÙï¦ãf[&ÍÎ/bPS}•c"8›• ö½Å ²ö”ßïs7>èö;™ ɤ_\„‚Åïp7¾ÏÝø0±k•fÑM¸›Eè!X|ö»é«AŸPµdV(þèn°¹ ZÔ@åµ**•㑊%Œñ"ÐTêûÜB¦FWÊñW”Ô Ü"ô,~‡»ñ}îÆíq6ËW½&lø"ô,>ûÝÀ|«Æ¿`@•â©EEmUEIäÅÖJ-Žý­Q®FÝçnü&dà“y9JiÑY§ñz¿ÃÝø>wã7!S"o´âG3Û¢¹=‹Ï~7­´Ö »+•”?êþ¡¨È+kä®ÒSÜÍõd8A"¥bV$…Å}îÆ} ëG7Ë´F}=‹ßán|›»á2–GqkÎ ½àDº =‹üß?ËÝMïݰ| b 1—aªHªÙXÉañz2V«5c¬`ÌÜ/ÞŸ÷Þ)ÞbšRã!¦)ïùº =‹ñK~‹÷ç½wŠÃ€˜q£>›p7«ÐC°8󻡵Wä8ͬ3E^4$E/Ñ2hÇd^*-~¸G)Øzf/ñýyïâMÈ@‚AÑÆ{Gf§øz?ÃÝÜŸ÷Þ)Êí[o¸H+eâU¼ =‹Ïºl6ëÅ:cÎ>™5Œæ·Žÿ¹€œÉ‹Q º”$¾ù¿›ûóÞ;Å›é, 1ùÄnz?ÃÝÜŸ÷Þ)Þ„ ¶¶p$:’8¢É)¾‡‚ÅÉž)‡íLe-~ë¤÷TÃòÄø˜[ ‹?›<,êAL æòâ6wÃew1l_md<{£¾‡‚ÅÏp7÷ç½wŠCLÓ½F¢‹f~6…º =‹Ï~7]±A"~kXœ&yÔtç@c•Ÿ!D^4è[Ä1ˆŒA·¹›øÝî’EµG^mŠÅ÷ÐC°øîæþ¼·N±Þ„ŒK Œâ])æ“®zë£îƬU)*Ôèü’»m ¹“Q§øs[./Æ“K|Ùq¯IÕñ¿O±îs7õÓˆõÚâƒí nzëw¸›ºÏÝÔ›)~²ôÕçóÍÔ*ô,>ûÝ(„ì PH53j°Èÿ¿´î~í™ÊäE½ŒQÖSuí(ðë÷¹›:–G]u8üÝÚôßCÁâw¸›ºÏÝTÉ®EKÕj¼.';ßV¡‡`qâw©‰±Ö¦Æ/ì5Þ9ñ½Åò6î3y‘Ù:f!*fsXÜçnê1M$~eÈÑùY±± =‹ßánê>wSÿ BEW¤Z”q³S|=‹Ï~7‘Á1*É„Z“yQàÝ9uÓTúóäxhü(C•šÂâ>wSoB¦ùOþÇi™œâ{è!XüwS÷¹›z2Š(»v†N<üW¡‡`ñÙï¦F ˆ—Ìà’ÞSŒI`XVAºYS5êõdé…Å‹q~â>wSo1©‚fêXZ3án¡‡`ñ;ÜMÝçnh,‚/žš¦“[âEèX¤G݆÷wgÖ’šÓ(ÿPtÆR°ŒY»h–G Æ÷â3Y«Òÿ}Š´ÏÝÐXÕE¬€¸­3õÔ"ô ,Òw¸Úçnh BQ-½Å‹2ZˆI׿=‹º+ØàR8¾ßQ¬f=üQ”+K«Qš×žLRp§@NÝiÐ>wC·˜F ÷˜•±¬`’¡‡`ñ;Ü ís7$wû ³X·É]ÿ"ô,>ên,Þ‘½F­Ø{Ö{ª`«V) ¦[5Û/Âíò;- SSXÜçnè&dT¼ÃI@üŸOñ=ô,~‡»¡}±EC•MÜüV¡‡`ñQwƒmB½†Kr5êþÛøeÞž ™™©ëÉñà¨Um¹uŸ»¡±<Ê‚ý=µÙ)¾‡‚Åïp7´ÏÝÐMÈ¡ö´xƒkð¨‹ÐC°ø¨»ÁZdsÅ ;Y²F5þ¬¥IUÌQÇë~^Ä“¯E¬ñŧõö€_§¸ÏÝÐ0±¹®_Ó(mÖi¼‡‚Åïp7´ÏÝpW¿QG ?ôY§±=‹ü¨»‰Œ$êDÚ£JÕ¤Î;‡½h˜KšÉ‹ñd/Ò«äüQïÏ{ïoB¦Eóå¸Ï<6V¡g`‘¿ÃÝð>wÃ7!ÃÍÑ{™iࡇ`ñQw£†kEƒkVIõ‹ÿºÁ`WÓ„],u×?Ù©EFÅúØ÷¹¾ ™N=ºxîìZ'5ê"ô,~‡»á}î†o1FW¢£‰¯ŒOØðEè!X|ÔÝ(Äk]šâ®ÐRsýåŽÚ>—µUç’äQFÉaȨ)ï©ûóÞ;E½KÌ-Wó>õð_…‚Åïp7¼ÏÝðMÈ\âå(£°w#ƒ‰z“;±êŒ»Y„žEùw#ûÜ B†IZ¹”“­(«ÐC°ø¨»Ñm‘wêÄÄÙ¼è®ìÆ\®i䤞Ü]Ý(jÁœUö¹á!l+(¤/×¹‰’qz¿ÃÝÈ>w#À˜É°)ê°:Ãâ{è!X|ÖÝ€{‘莨¸¬³Ó_<*Fà-ª[ê½—ÄÀÕ­Gu‰‚Ùõï÷¹¹Å4ŒWŽôv¹ONñ=ô,~‡»‘}îFnB¦"›^ž.ÑMNñ=ô,>ên¬pTcnQW—b©oñ'¦ &U”ã=äÉ=SX¢ ÈÉðOaqŸ»‘±<ê§'V£2Ù¾ =‹ßándŸ»‘AÈD/UÅLâ3ëßCÁâ³îÆ‹×WÒ$³Zøg/q {ÔäÅÛZÞýW¿ÏERîj\r8Ùçnä&dœT;6ÛÜ· =‹ßándŸ»Ña@ÿkµQ›Ýõ/BÏÀ¢>ën`ÐC˜õ¬ÇFEqz¹AZšË‹ñd\‡oêzóã¿OQ÷¹½ ÀÞa“S|=‹úîF÷¹ƒPZâ﵊—É,ñ"ô,Nt7=ÊDxÎtJzøWb@¹V„—Dû£»‰Ï«ªXǶ©w£ûÜâŽE0o:顇`ñ;Üîs7:¡:ÒÜÏúìßCÁâ³îæZ3\Ã>Ôl^lÚ[ü|SÇnû\^lÝô½*$±),îs7:LlXà&¢­”é)¾‡‚Åïp7ºÏÝèÓ\Ûâxj³S|=‹Ïº¥øÊEzj°tJÎiD^dóR ¾Ukú导¨TáϪ;¥xTÝçnô&d®9ï¦%ËdCÑ*ô,~‡»Ñ}îF‡±F;Ô¡Q{NNñ=ô,>ënâW¾ì–â—¦žÔ£UI‘JëÙ¼¨ñòêØu(\’yqŸ»Ñ›ipS6ƒ¬N¦m¡‡`ñ;Üîs76Ä4ÕZT`ÑLÉÌqzzíYw£VzÕn^EÖ[ÿÛý"q4ŠQiRÉ:þäE‹v3ž®ë ‘Ÿ¢ís76™ÀUo%^µNºþEèX´ïp7¶ÏÝØMÈÀö´º;Ô)“)ÔEè!X|ÖÝhä5†ñL-´ž"üÛcƒ KD0 /³œŸ¼ÈÎ$î¸@HÕ¨¶ÏÝØXü•JSF&“[âEè!XüwcûÜÝ„L¯&Ôü OjÔEè!X|Ôݨy‹ÞÈðÑ–ºëÿÏ?Ÿ ¶†InY=je¦[„‚Åïp7¶ÏÝØ0±q†ßYÇ”ð ‹ï¡‡`ñÙïžÝ¥“y¼H2W„ë‘>Z-M"¥š&ýQ£D…U1ö`„>…Å}îÆ†qüé¬wŠ4>Ù¾ =‹ßánlŸ»±>†‰50Ffwý‹ÐC°ø¬»Ñ*U¢\ÄÞõ¦îßy±Å›§Ã'#€¨w“É‹EpÞ+$ç÷¹„̵ ½—†™’É)¾‡‚Åïp7¶ÏÝ´abƒW·w˜[Ï<¡g`±=ënâÝ•"u¬ÌiÃqEX¼‹bjü©“ûãÉšÁa5zÍÔÌTÛçnZ²ýÈÝQI“MÞ¨‹Ð3°Ø¾ÃÝ´}î¦ÅßH‘;â +3,¾‡‚Å©ßF~##±–Ô£2žz$7bØm¤ýn£mƒ“ªQÛ>wÓ!#MÉ´6‰ trŠï¡‡`ñ;ÜMÛçnÚ„‚4×½Îæ4¡‡`ñYw£qÃX,ëJñ/U±?$òH%¢«ÀMåEíìR ËÕJ./îs7í6±)ÈÜÆñÓ9Eè!XüwÓö¹›v2í›á‹3s¹]„‚ÅgÝMëþC¢V§õDïïSŒÖJ”FyñJmÛžŒx²G:m%~ƒ(îsXÜçnZ†Rq0[&·Ä‹ÐC°øî¦ís7í&d7:¸$MNñ=ô,>ën¼t…ªÔD %kTrØûà_ÃɼèXqÅ(p½æ<Û>wÓnBFÈÌ‹–!ÏNñ=ô,~‡»iûÜMbšV]¼c×IŸT7‹Ð3°ØŸu7×”3$ ªÙý‹p×J"$*)îæz²Tïb5*{Z>ùß§Ø÷¹›~‹i æ‘.ÅXfΚ‹Ð3°Ø¿ÃÝô}î¦ÓŸ«ßbRD°˜~rŠï¡‡`qâw#ã¼ ºyNÞõ7ãw±‚åmÙ½Äñdv (öÖ©¦æúû>wÓ‡1c 2S™y2.BÁâw¸›¾ÏÝô›ÁëQ»ÃCnæá¿=‹Ïº›Vq#eܲÞS˜~ÄǨ~.DR>pptg {ãRXÜçnúXU¢îì¤&J×¢Eè!XüwÓ÷¹›~2ðæsVo¦ÕÍ{è!X|ÖݨÌÜZ4ºTòîmxE³(%’"•D{ó¨zŒ:WêÏ2Ž},îs7}WÆ¯ÉÆ"ô,~‡»éûÜM&6Q®«Ík›žâ{è!Xœèn®}ØÒ œhr/q´ej/­¸æ¼§®ûÅËØÃLÄÖC¿NqŸ»é7!S/ik”.3ÔEè!XüwÓ÷¹ÿc@\ÞØÅûlçÛ"ô ,ú³îFœ Û׊JrN#ò¢xiŒãð®ÊæEñV‹Å; »ôÔü¢ïs7>™&Í,Þ‘ïf§øzý;Üïs7>¡ °Œm6¿¸=‹3ÝMTÖ‘š”4P‘Ì‹¸PÌ!»ÖÌ…È»k‹Â>JÁ–ê}Ÿ»q¾/ðµytÖgýâ"ô,~‡»ñ}îÆÇò¨yNUJôò“uzŸu7ñ…ƒN¨&Íò;ß°‰¹W.©„)ÀÏœFt‰XxPÄ~ìcqŸ»ñ›qØÀ×§•™Ü"ô,~‡»ñ}îÆÿKL+ß(§¸N`q¢»©Jv–ÈlšÔÀQ‘(/™º Á-Çÿªa µšô»ñ}îÆÛ¶9–ÛyŸm [„‚Åïp7¾ÏÝø›RÈ£5Ø>Ÿâ{è!X|ÖÝônû©®0>Kênjë­—¨5q%—Â"žì…#+¶($xí’üë÷¹Ë£¢™Æ¡ºñÌ“qz¿ÃÝø6w#å&d`w †;zˆò|K¼ =‹òß?Ë;/bˆHëD”Í‹µ¨‘?`֔͋åø¸©µzÞ{§8Ll"y+9&zö»Y…Åø%¿‚ÅûóÞ;Å›¡b=•ÁP깺Y…‚ÅgÝMk‘Ù:W(hz6/–è«¢¸61¯¥3åEX’@b%}“LzÞ{§ÈƒV3ïŒeÂÏÕÍ*ô,~†»¹?ï½SÄñ…!Ãåa$É)¾‡‚Åç=Spò†‘Ëø&u7D ]ÖùxËq7דÆ|͈ ½Î`q›»‰÷ÄXu®1Æ“S|=‹ŸánîÏ{ï!SÑI©Åw§=w«ÐC°ø¼g*~×€BeâJ–ôð‡£HÔ˜†[’½_Œ'wX£´p)îæþ¼÷NqˆiÌ"íK‹&b¢ð_…‚ÅÏp7÷ç½wŠýNvZ+®À¸ëä®zu7 {•ØÑ²éÏ:ÓL^Ä‘hª.>Õ“÷‹ Ÿ žÜª¥f‰ïÏ{ïoB›;zC“â6«nÞCÁâg¸›ûóÞ:ÅúgŠûw+ÛdÓû*ô ,ÖGÝM“^#X#ø©5ò"õ.Ñña–˜KÒ5žŒf,žÑÝÜŸ÷Þ)Ö!øf…´ ºôçûÅUèX¬ßánê>wSÇâo*ñï¨ÆÈ“¼¸=‹º›ÖaZZ·bÞ³ýbñBÎÆ¨R3Ë8®¼GVelã^?ù×)îs7u B•¢Q}jQ÷Iº=‹ßánê>wSoB&ª/f!´:;Å÷ÐC°ø¨»éƪñ±˜ëΆ™¿t7È$Þ¸ª¯Çž~Ÿb@±Xü$.¾VÂþ:Å}î¦B&y£ñò˜8¥¬BÁâw¸›ºÏÝT»’¼Fõ:é4¡‡`ñQwãJXR0L\Ö í¿ô¨Ý°‡#þÌ)OæÅx²9¦‰±jj­¾ûuŠûÜMý/BFº—йåÙ)¾‡‚Åïp7uŸ»©·˜ÆâÍÚÓaî29Å÷ÐC°ø¨»ñøÒE‹§ìBšÝ…Š•è—„.*Í–ºë¿žl˜Áž+]/ãøuŠûÜM„ŒK+ÑÊcždr¿¸=‹ßánê>wCcñ·DãëíýxŠ‹Ð3°Hº›ZX:Šê¨®ÛeÃ?9ÛǼˆŠ‘W­BßÜ3U±™Ö¢±fÅHÄêÉÿ>EÚçnhˆipiÕJ‘^'X\„žEúwCûÜ âNÞô{üÇäßCÁâ£î&Pä¦Ev×1¿±•ayRwS‹–ŸVa2º:Õ},îs7ÄCØè¢xu4™ìB]…‚Åïp7´ÏÝÐ0±©ø–R|cëd+Ê*ô,>ênjНWŽdÌ‹¯Ÿ¨åž"Ù9 <cSÜÍW³¹Å}î†îA¨¨W¼F‡Ú¼N¶¢¬BÁâw¸ÚçnèÓÀF‚(ê"îgÍUè!X|ÔÝDƒ[aìâFÑ0R2/VW¯ÜX öwɼOönNÇÝ—ù×)îs7ôgªpìÝ¡ùžœâ{è!XüwCûÜ ÁD!g¨LNñ=ô,>ên*“ÆÑ¶Qÿцgòbe§V™ÔzIçÅ(m1nEñó½åjÔ}î†|PÜñ?ÞÄJ$½É)¾‡‚Åïp7´ÏÝðMÈ€S½Ð¢žšLÛ,BÏÀ"?ên*䨺¬¥öu×öW^,Ý0#8Ć´d^Œ'÷H¨Ñ uºæú·±ÈûÜ  K›Ç‹²ÍúÅEèXäïp7¼ÏÝð d ò*"¥Z™¼Q¡‡`ñQwƒÛP“€DÃ2å,Z`t/½]-c–G…å¸[+@cNaqŸ»áAÈH“ª±÷ÉvéUè!XüwÃûÜ åQ.¥)VvŸåÅ÷ÐC°ø¨»©WJlUŠÁ­'—ãK¸Ã©ÌÔ8¹—O6 Ç—¿´\^Üçnx,þŽjº›ã¸Uè!XüwÃûÜ ß„ ø¾xOâÿ@“~qzu7•­ÀÇ7R’ý"v°Æ÷V xÊù†Ç“+ -ªÇƒs<*ïs7|‹i¼ãêÄÜk¼'§øz¿ÃÝð>wÃCLC(maf¯âUè!X|ÔÝT¾¼j1zIgy7­©öN°;NæElã*îÐÑy÷¹þ3ž˜;jê‰nz¿ÃÝð>w#CLãÑØàýÝ\&Æ"ô ,ʳîF ¶ RdFSZvmåÅȨ˜¼-X«qYœfò¢€ÖÖkËøÝ6eŸ»‘:,ÀùêãÏ9;Å÷Ð3°(ßándŸ»‘abõѦMjÔEè!X|Ö݈`r©j4»ª),F¿ÿ¿H«¥h¢d^Ñ¢Ü/oFÏaqŸ»‘±ø)×kCglø"ô,~‡»‘}îFnB&НŽÝdT£œâ{è!X|ÖÝ :­¥^Û-ú²kû}ŠO{©Q¨FÇH©O†9jí ‰¸¥îúeŸ»‘±øÛj“ÒãÊT&§øz¿ÃÝÈ>w#cyT­&Öà2q¹]…‚ÅgÝ´ÿ/½ì$K²_ ×c‘2­m2þ΋­c—”|¸ûXÜçnä&d¸“0 €^§X|=‹ßándŸ»‘›!-Ô±b†ó“S|=‹Ïº›HåÜAS-™+â@ËŠuß™%U?y±_9µ"§æî4dŸ»¿)nÌ$R¼&[™Ý/.BÁâw¸Ùçn´ a›cû¦¤“ϧ¸=‹ú¬»QkÎŽ+BÍên*a¤ßJu¡žÍ‹j]~;Qׯ«ãŸ¢îs7ú_‹¿{õ¢=ÚÀÉuzõ;Üîs7JÃ8#ª–¢X‡4{£.BÁâ³îO8lFÚ—•âßzÔHhQ ¨xçÌ’*þyr•øÂÇS{-)Ýîs7:Llš81GþÖ:án¡‡`ñ;Üîs7z2NØÈB 9&§øzŸu7VLì0 ï¹Yâkì)úÅHo`Ž)› Êð¨7±ò€–*ƒ_§¸ÏÝè-¦‘JÆ‘ñ.YÔäßCÁâw¸Ýçntˆi(ÎE¬ÛL=µ=‹Ïº+Kªì}c¶_ÄzY3ãb$¹OOv„܈{ÏåÅ}îF‡˜&ZÓN{ú„»Y„‚Åïp7ºÏÝè dj½ˆÑÚŠOÔS‹ÐC°ø¬»±ÈLý¢)l¤’÷‹‘Pá8\âG»hò~1úÓ(I<>³ÜÌ”îs7:¡*œk©–:uó[„‚Åïp7ºÏÝØÓT$»ø¶˜ú¤_\„žE{ÖÝÀJ?бøµ]Ö•â_÷‹ñ­RZ‡­bMañz2ƒonU+®€X´}îÆnB¦—jU{üų E‹Ð3°hßánlŸ»1W¿ñßÀsÇ M”Œ‹ÐC°ø¬»1oÍ´vìÞN÷‹àBÕa PÓý"¼âE@Ðþä°¸ÏÝØMÈT‰Ä¯XÝÚëìúz¿ÃÝØ>wccŠ¢^ lY%žâ{è!X|ÖÝ€AµŠÝ°éÉö‹Í½i¼}„³sýñÎâ(mãS«”ãQmŸ»±1Ž?_£&“]¨«ÐC°øîÆö¹» ¹¶¢)µh¨&<ê"ô,>ënLõÚ×|½G’zÔZI9 h—[Sb‘*ßOŽ´ŠÕ8M9¥³}îÆnB&*"è×k)>Û¶=‹ßánlŸ»±›(Ë¥m³Y§ñzŸu7‘Æ‚R&,nKß/v'®îORMåÅ($X`´¡ñø÷¹„ WlQv÷©ßÍ"ô,~‡»±}î¦ o½7ÜÁÕÙFÛEèXlϺ›¨OK‰ U±'8Á Âôº_¬lE®«Ñú-ðïSlûÜMbšÊ-ò~üt¦ð_„žÅöî¦ís7m,²Ö7“Þgó‹‹ÐC°8ÑÝT\ FJwë’Õ£VŒnÃQ¯'k­ÿAÖ[J×ö¹›v2Šá tkÝÍ"ô,~‡»iûÜMË£¼a'Ž`Øäfjz'º›†k ŠTÐKΓñGJ"½`µ§ûÅk"B£âÄŠµ÷¹›v2NPÝÆÛÒ¦s‹ÐC°øî¦ís7m2B‘îðú¦>¹ÓX„‚ÅgÝ͵+ªÄø•Ý’sýQ£Æ[þ… §jÔëÉÌ¥vìÖé”òØhûÜMĽcØRØã:9Å÷ÐC°øî¦ís7mˆiâåå[­<ñ»Y„‚ÅgÝ ö½qkQ¡6JÏi`Cx-QË•{8“[tÕÁZuíîñë÷¹›6Llè²ÉꑌmVݼ‡‚Åïp7mŸ»ée\àGè=¾­¥M¸EèXìϺ›NXR£ºn&Ëìôßô¨à_,ZÆ¢ëŠåÅgTÅúÆøÄRwý}Ÿ»éõ~MÆïù. cÑÉuzûw¸›¾ÏÝô›iV°?;ʸi¿¸=‹Ïº›H‡Æ‘ͯík),"/¢[¬ Æ;eóboÌQ!«w÷ÜýbßçnúMÈ4‰ä©âúprŠï¡‡`ñ;ÜMßçnº †:A#†Ù×É)¾‡‚ÅgÝ[«¿±ô^r^Åè£Ê‰×Œ6²sñd'e‡\KÍLõ}î¦ß&6z“’ñgåÅ÷ÐC°øî¦ïs7},¨RjTñÅ›œâ{è!X|ÔÝP‰~-ÐðºFÄß<ªÇŸÔ[/,$©õzrUŽŸ´Èª’šÓèûÜM‹¿£¯1Ñ'º›Eè!XüwÓ÷¹›ÞoŠ»µfν¸— ¾=‹º "«q)DëÍkåE\,6uì5;× Á€£Ufv[º^ý:Å}î¦BFþ|ØsJ“[âEè!XüwÓ÷¹/ƒ…7à‹¬Lî4¡g`Ñu7ÐeÃÅ?š>xŸe÷[¤Õ†ýšÜKŒíâRbhSÞS¾ÏÝø’ª‘ézŸià¡g`Ñ¿ÃÝø>wã7!#%Zù¨W¢­šåÅEè!X|ÔÝöÒ8aª¿m0(åEXlD§é‘W«%÷L]Ëâ`.S0q•Ãâ>wã7!¯In×"ÝÍ"ô,~‡»ñ}îÆe\àkMsǤÝäßCÁâ£î† V®•Æ^T8¥Ãu=ãúF@<’¤¸›ëÉÚ0¨åªÝRzTßçn|,þv¨àaçQi†Å÷ÐC°øîÆ÷¹ÿ!dFŽ—bGEg5ê{è!X|ÔÝ`OÃEˆ/Óy±W§±ÁøÎ“þ¨ÿo-R±Î)§»ñ}îÆoB¦1n # c!ùäßCÁâw¸ßçn|,’BG]Ž/ÞäßCÁâ£î† 5l´€›ö¬,}£ @©IšæQ©3EbĬÇÚ±ü×)îs7>¡"ùâ6[“;Eè!XüwãÛÜ–AÈ4í°ª®:Ûİ =‹úß?ËŸ¼ØÝÜ(þ=Z./âZ¢S´ŒvÝLdó"êˆf&Œ¡ÏïÏ{ïoBÆaázmå£úœW¡G`1~ɯ`ñþ¼÷Nq,þÆÒhÔb GÝçS|=‹º*íòv¯ñá$÷iP 3™F1W4©»‰'7.ÄD ³®·¹-CL£¯Jvâr» =‹ŸánîÏ{&ZøÞ8zùRžkÔUè!X|ÔÝPäpLj\ JRws´Ç]=ÂâõduE…ÜK¦_¼?ï½S&6M£-EhßðUè!Xü wsÞ{§øgyTƒ¨`Þ{–ßCÁâ³î¦b³ z¶Âm])þ•QÉU±†… ›º_„êþªœÒÝÜŸ÷Þ)Þ„Lü¢Kwu)³¼øz?ÃÝÜŸ÷Þ)Þ„LiB°ä¥Z&ÜÍ*ô,>ën©ÏÑÞ9éGÄÍa)"`”d^$¬WSb‚¥dî4îÏ{ïoB†+©Pü¶l:;Å÷ÐC°øîæþ¼·N±–û5Èj˜z‡ñó).BÏÀb}ÖÝ\öO€b£ÜòbT•ËeNÙûEbÜmjÇ&à ë>wSoBFq.í­É„[„žÅúî¦îs7u,þ–øº l}²‰azŸu7ĵik¨2{r~‘J¯ÈŠñóÚ%Ë£Gد+ÿ*9,îs7uˆi7ðS>™_…‚Åïp7uŸ»© ˆ«Ñžu7«ÐC°ø¬»©Xô åLàq])þ}¿Øè1io¹Ý6ד#+×ZEJª_¬ûÜM½ ».*P׉uz¿ÃÝÔ}A(’ï¨K&¾á«ÐC°ø¬»‰ï[˜L³ºahR«^V–G….\ ܺZÊ7üþ¼÷NqˆiºG-Æ “S|=‹ßánê>wS!Ó»À²0úªÉ>Uè!X|ÖÝ7`ÁÀäç¼§þsñÿQ_ qç–«Qž_ù‚Q _Oký:Å}A¨x ÃeQv ?Ÿâ{è!XüwS÷¹ºÅ4‚ØêX“Ñ'yqzéYw•"Fž@Thz®¿ ̧¢6‡$5u§q=ÙØ=Þ]•DfNãþ¼÷Nñ6±‰7†¡%.ñËNºþEèX¤ïp7´ÏÝПA(éÔp59½ë_„‚ÅgÝ ‰*wܼ¯·=ý•»áÅØ@Ë—ÕÝP¸ÒêÕ2÷ç½wŠ7!c(¥©Gýi6{£¾‡‚Åïp7´ÏÝÐÓDÊ hè-þOÏ«ÐC°ø¬»¡¨2‰#19†5²wCCL£%ŠO ðk™p7‹ÐC°øî†ö¹º ˜HC"ÆÊ³~qzŸu7¸æ'«M’d}Ë ²rѨ5swýד•:ƒëŠŽ1¥G¥}‰M­Ü=~2JêÙ)¾‡‚Åïp7´ÏÝÐ dÌvóÖËÄnz'~7P¯i†=¹uX K/yõçúG¼YÊcãþ¼÷Nñ&d$m-’´ß“S|=‹ßánhŸ»á›1H.aBÄ„[„žE~ÖÝT©Þà_×1Çž½_”FÒX[ *»g •v¯Õ/ýM‹¼ÏÝð d´Y4ñ°$šñ¨‹Ð3°ÈßánxŸ»á±<ªE/I‡àäßCÁâÄïÆØ¢&3hBsp2Àœ˜cq(YIó¨&sÔâ;¯©; Þçn˜ÇP"Èbê­ðŒ _„‚Åïp7¼ÏÝð-¦)t™ž Š© ¾=‹ÏºHB[)UÕzŽ»¹òbáøãÃà§IjêÏ“[ U<µñþ¼÷NQÇ¥!ž±3þ¤“S|=‹ßánxŸ»aÆXú­ycâ=µ =‹Ý ÚÅŽù"þ΋MUd·«çLû£Jü¤ 6W”œî†÷¹bxHKw‚ääßCÁâw¸Þçnøq|M¹â&\gX|=‹Ïº›êª3½bšÛ…zÙG5kÄ‹µKÚÕ DM¼µwÃûÜ ß„LT⮦°ËÔYuóz¿ÃÝð>w#7!Ãñ¥(X°:zrŠ‹Ð3°(ÝM‹L^´{¬²sýŒM…5zFÑÜÌÔõdl_%x òzÃÕ¿OQö¹Äpç‹wF5Ÿyl,BÏÀ¢|‡»‘}îF†˜F0Eoqè '§øzŸu7XnF—±kKêQ£ãƒ¬¡Ç+ލ¤îúžì°öp¥Â)Uö¹ù³ø[<qôòÐø<Ÿâ{è!Xüw#ûÜü!dâ§ôò…áÉ-ñ"ô,NünPYcf‚áu‘ž_,Ñí±0ƒÊæÅø¼GƒEPªF•}îF†±´e´U¹¿¯BÁâw¸Ùçnd2P'ƒQâ{è!XœøÝàFà<ý󨫵¢N…V%«G­Ö‰¬G!XUryqŸ»‘›ÁÐr‹ Þqƒ?9Å÷ÐC°øîFö¹¹Å4ÑÂs$€VÐÐONñ=ô,Nt7Ü$²b5 hdïU{iØ>¡Æ%u§ñóäŽý±t1^),îs7â£d‰>^àÛ&{‰W¡‡`ñ;Üìs7:¡Lq–~æº=‹ú¬» H¸Ô/XY—Ì‹QáJ$†5ßéý‹Þ¸(ìr·d^Œ'[T‘+–Žf°¸ÏÝèMÈ8qï 3.=ê"ô,~‡»Ñ}îFoBF Ü»Â-mrŠï¡‡`ñYwåŒ6‡´´¯ÙÌßy‘É;LäÔÕš‹’È‹QÕF_¦-éªûÜŽA(†©ƒ  ˜©Š¡‡`ñ;Üîs7VÆPbi†uÑm:¾=‹ö¬»‰÷G­jÐCSÎî?ÿt…Å©Eqë½^Iu‹?O–ÚœI$7×oûÜÝ„L‹×°a^ãa“S|=‹öîÆö¹„Œi…}-VLª›Eè!X|ÖÝ€³»²’VÏzOæ" ³ÓeY“é­2ö¡–‹²Lõ‹¶ÏÝØXeµ•ÖãeÌ4顇`ñ;Üís7v2Ñ@˜[+ÑNߨ`ñYwƒ[E‡AÔŒkgÄ¿î4¢2íM{«…†<2ýb<ÙÝbÔ %ì¯SÜçnìÓLzåèègs‹ÐC°øîÆö¹„LH 6¢>»_\„‚ÅgÝMƒ²Û£¬®Õ)» •Ñ[©hTªZ²y±EúÁfòVicÛܯSÜçnì&d¢˜ŽdW+4 ³Nã=ô,~‡»±}îÆ†‰ Å÷ó3Øæ69Å÷ÐC°ø¬»¹t/­"ôÿó+V(Bãݸ—ÔÆõdޝwÓÆâïέѥé$/.BÏÀb{ÖÝtçÈoÑáVKÎLi´Æâbµ`>¿'ó"¼ÖH0y­RwýmŸ»i7!Czc˜ŸÚŒG]„žÅöî¦ís7í!i%v›¹ù-BÁâ³î¦·(M1¾H ÂT^´ø³¶(o ­É¼OV‚ÛšG~]*aâ>wÓ!ÓJ¼-(r0ûD·=‹ßánÚ>wÓ!ãmVŠÒsvŠï¡‡`ñYwƒ™z—Âbù§_váµT7í×üb&/Æ ;[dGJæÅ}î¦ý!d`© ;š¹ù-BÁâw¸›¶ÏÝ´±<ª˜º8÷F“~qzŸu7@ä¨Ý‰1éÉØ[×^ Eb+RSÜÍÏ“qÉß-Š\Mõ‹mŸ»iÃÄöÑÌpWžmz_„‚Åïp7mŸ»i7!CðYãß\&7S‹ÐC°ø¨»áb¯UáÊk%ÚïSô"åZÖ™syOŽŸÄÐ.ŒÖSXÜçnÚ0±Á@[¥êfê©Eè!XüwÓö¹›~2Ãç5ÞüñžœL¾-BÏÀbÔÝ­EßW«)ew¡vGb¼¸-žœÓ`˜.Ô£3ËÍ/ö}î¦A(lïp˜@F:9Å÷Ð3°Ø¿ÃÝô}î¦bŒ$ŠX´7³›©Eè!X|ÔÝpôzNŒÿÞ×ÛÿêA¾4¨7ÕìJm™¼XFù.‚+Ù”®ïs7}˜Øp÷¿¯KœÐäßCÁâw¸›¾ÏÝô±ø[0fýƒøLá¿=‹º¦*מîÈqœ›ë¼Ç´¨´Qà)u§ñódì%†Sެ'D~â>wÓÇò(w©~É…ë„»Y„‚Åïp7}Ÿ»é7!SaaƒÝf%ÚªÉ)¾‡‚ÅGÝ sºŠjŒö&=6Z3* F[Ñ6z6/^—“¾ÀL¹Ý6}Ÿ»é7!ÓK籟èLU¼=‹ßánú>wÓoBÆ¢¡i›nEY„‚ÅGÝ SÈL¤ZvNÃÆU…^9”ÔÝàÉ +{4ŽÚR¸¾ÏÝô›éÊFܼ—Ö& Ü"ô,~‡»éûÜß„L$ «P ãÊâù¡g`Ñu7QO[µ®CÍ–ÔÝT´šd0‘+žÔ£âÉ‘PŒüs8ßçnü&dD ,úqvŸp7‹Ð3°èßán|Ÿ»ñAÈ\/ŽNÞlvŠï¡‡`ñQwgeöhuAågu7‘ÏÄ=ò›Ãy6U£þwã|·˜Õ'*…;Íި`ñ;Üïs7~2ñÞ¦Z¼;æ‚&§øzu7ÏFžQk‘زyFŽ,ØVú%{¿ˆ½8ðæ¨øLí™ò}îÆoB&þpp±èpuÒi,BÁâw¸ßçn|ˆiâÕ]£…¨ñŸ³7ê{è!X|ÔÝ0—®„Íæi1;¿½f-]ÄãŸÒA…Z"/ÆÏËZ¬±¦æ}Ÿ»ñ›ÁòcúÇî3%ã"ô,~‡»ñ}îÆoB†{ÉâíÝѬF}=‹Ïºï‘œÙ»%g¦¢Ñ ƒ>®QÖ¥¼§~žì˜ éѧRê~Ñ÷¹&6žµ¦–ϰøz¿ÃÝø6w…×]xâ6Zq4&Ïwý«Ð#°hÿý³¼ûESÌÖ+Ìü“>pñSŠ[1²¬î&žlª­”hSº›ûóÞ;Å:ÈÑBÿ©Éguzã—ü ïÏ{ïiJuóÒÉ£”{î4V¡‡`ñYwC˜Š4Þâ÷Îî%ÁŸ™èÂcOÍLý<«€NMaq›»±r2…«blºTšbñ=ô,~†»¹?ï½SƒPQp‚ò×÷dÏÔ*ô,>ënX:.¶ùr®ÏÎãÀɱí›%›ãɰgŒ‰p./ns7QDBF¢îŒ'YñgUñ*ô,~†»¹?ï½S´aœÑš’à6[ž«ÐC°ø¬»,â‰r‘¨GŽKÞõ“yë Õ{–GÜjAö£=—·¹+ƒÁ/ï xlÍ:÷ÐC°øîæþ¼÷Nqc«"î´z÷ßCÁâLw£TÐîañZRnJ&¦Ø÷Và_˜ÕÝhà±`¥“Õ\^Üæn"µÝ­¼ªÀ=ƒëLá¿ =‹ŸánîÏ{ëëB†PJiéñÍy>ÅEèX¬Ïº–(«±&ʹY²_43!æF֙Ӻ̖ydÅH@Ry±îs7õ&dÀ±p7l«œâ{èX¬ßánê>wSÿ,ŠÊSwSÇ T÷xO6b%ð¨‹ÐC°ø¬»©H¤è©¥½§Àü·Ö/gçú±fÊ4пAÆ{êþ¼÷Nñ&d¢ÇsæB<ëú¡‡`ñ;ÜMÝçnêÓà`„âKS';ÂW¡‡`ñYwSá¥Ê!*MæÅ§4·è“52d–G'»„;T{ffêþ¼÷NñÓÄÑÀ³J´©ÌNñ=ô,~‡»©ûÜ •!l‹#Á«_ËD¾ =‹ô¬»¹Ìñ4ŠÅ(Ê$y¿Øp% _€øæŠfçú¯6, o¥­ÜŸ"ís7Tï릢„¥ø'÷‹‹Ð3°HßánhŸ»!íCaÐèïËg±Uè!X|Ö݉b¡Q­%j²Ôž©È‹T(PiäòÈúÀŇDÎXéD9•ö¹„L)ðœS‡wÃÃÄ&þeoK ”MNñ=ô,>ï™2â³³,JIU\¨W—h¬p1žÌ‹ñd†ó8t¹~‘÷¹Ä‘ÀÝ¢¯me²‰az¿ÃÝð>wÃvÓjÚ+R^4ƒ2顇`ñyÏ”á½QÙâEÂ%É£2ì Å ¢Ž¬šÔ£Æ“!ÂŽv3²kNÊûÜ ·ûÒ0’%0L2Ùh» =‹ßánxŸ»á[LÓ(Š–øžªùL·=‹ºR,lëXJ EjÒï¦öÚº|à’¾áx²)¬nZTÈßðûóÞ;Å›‰·c)Ø¥EÑãNNñ=ô,~‡»á}îFÊHvÑ7`‡ ö}>Ÿâ"ô ,Ê£î†.ÕM¤Æ&"ÙoQØvÇ߬Ñu!"‰¼O6˜<aè*ƒEÙçnd˜Ø¸W“Ö bŒÉ)¾‡žEùw#ûÜŒA¨h›7!!›¼Q¡‡`ñQwCªÞ¢ÃbÍÎLa ‡—xýXñ¨²yQ½w8 Tã”Üýyïâ-¦ah‘êpŸâ{è!Xüw#ûÜÜ„ _Ë>±@WiÒõ/BÁâ³îF$rZüºÿÎjà˜£ÕŒf³¶ µ@²_Œ'÷"ÒS-©; ÙçnDÇ€p…¹CZ0¹ë_„‚Åïp7²ÏÝÈ-¦‰š%΃¥mƆ/BÁâ³î†© Gum¨U“w¢°ŸŒ·O¡K/–Ë‹ñd…_—7¢µâç×)îs7ògñwQ–HÓÉV”Uè!Xüw#ûÜôqݤ2†Nkâþ¾ =‹ÏºÜj㦾¸h_f§ßy:ÒkÃ]#¾/™ñ䨎%ŠÕ£ã},îs727‚°Ã™yöF}=‹ßándŸ»ÑAÈHÁb²FR'þ«Ð3°¨Ïº›èó·bÝ#d÷/FƒÜ+‘õVX“¾áד½ÂÂsÌ,ê>w£u %†ÑìßCÏÀ¢~‡»Ñ}îFoB¦EÅÂ¥^ ;'7S‹ÐC°ø¬»©K…á¹àJ&93e œM|y#A¦ç4ðdc冩U÷¹„ –†@;ožIu³=‹ßántŸ»Ñ1Õ¢f©ñ­!ø‡>Ÿâ{è!X|ÖÝTh´=þ#Ýšìk‰ok´Ç°¯—˜ur¶yO6'ƒçøšÁýuŠûÜ1 wc7!ƒ)¨ÂWšNÄ¡‡`ñ;Üís76¡ ØÑ(\À¥ONñ=ô,>ên¢H„T䊭<Ù]¨ÆÈ"ÚZü4eó"Ò"[1‡_N ‹ûÜÝ„ ÆI ΓÌ3mø"ô,~‡»±}îÆnBÆA.` ª÷w³=‹º›Ú£[,Z[‹Æ/w×_þ¹\£$2b~‘’ý"žlµûzrò×)îs76 ˆ£œŽ_Qk‘i§ñz¿ÃÝØ>wc}Œ³Å{8ºyÃÖšÉ)¾‡‚ÅGÝ ~iîDݯ–1=3UÝ1l…MS%™ñä…}4‹ÔR3S¶ÏÝØÓHõkqÖÖLNñ=ô,~‡»±}î¦ ›xCÆ—M¼T`qzÛ£î¦6ìzC•]Øúf᯼ØÙ ®ã˜}¢äýâõä É`ô3ƒÅ¶ÏÝ´±<*~SÌiFö/“~qzÛw¸›¶ÏÝ4º_“×Î]xÍÛÌqzzu7µa)ei‚wHÍλV­U»8z6/âÉ×%cq\d°¸ÏÝ´AÈ”*7¨Û„[„‚Åïp7mŸ»iƒsF|é¢r±‰îfzu7Ñòõj-ªêèŽr>p¸"¤ê"' ã^<—1p¨_‰ÔFÛçnÚMÈP` "väà‰6|z¿ÃÝ´}î¦ âÖ VÜJO:Eè!X|ÔÝDö†á~"Ù/Réí—(г<ªBìÃÚ[¼Ö î¯SÜçnÚMÈpTÒ-°;ðÙõ=ô,~‡»iûÜM&6ÜÈ)*¸.<¹ÓX„‚ÅGÝMÔˆPh›Ç÷¯d=©F-ÞcS(Í“y1ž\±4—ë ‘_§¸ÏÝ´›½Ý9*€ÞiÖ/¾‡‚Åïp7mŸ»écñwQØcG5Ƴuzû³î&^õº"Œz1ëáOQ™V\ÆÕ%]Vwóʽª¸´šânú>wÓ‡‰Mr¯,ÞgÛ¥¡g`±‡»éûÜM§!ÀPËM¨ù¤F]„‚ÅgÝ Ã$›ÚEågç4àѱھ+nɼˆ·@ÃhRô×I,îs7},ê°º¢ÒêTU¼=‹ßánú>wÓoBF üÊ\‹OwÛ,BÁâ³î†Kñhú ñIià`q*QaF"!¤’䜞ܺS/Žf5…Å}î¦ß„LÃ{ƒ;h¦G]„‚Åïp7}Ÿ»é7!£ìR¢†cr™añ=ô,>ënH¡Ò‚¬Á1™MaWSa|'éûE‚*\ù–å} ‹ûÜMÿcbµJoÑÜÚŒ[„‚Åïp7}Ÿ»é7!cð‚0ޝNô“S|=‹ÏºÌÎr'˜¹µµÛ_y$(ü'£±j9,^On=ð¯Q©fóâ>wÓÇò¨hJY;æ¥gªâEè!XüwÓ÷¹‹¿YãÇâ- Ää¡g`ÑŸu7Ѷſ]Ÿ®•h÷‹¥0ö÷‹åî4®'›cõ#Ã2Å£ú>wã7!ãªÑŸZÅÕáD=µ=‹þîÆ÷¹¿ ™Ö¢ËÞfzÔEè!X|ÖÝTâß¿‹žµú导ˆ0Úâg£AÎylü<9jŒíJËyOù>wãcy¤ExûLá¿=‹ßán|Ÿ»ñ›qŽÿ†¯[UÅÆ"ô,>ënÀ€Â†0zÝHŽÉ¼I™1ÚÆøGH2/B|çÜTJ3IÍ/ú>wãÄ4U» U옛œâ{è!XüwãûÜåQ]7H¢flø"ô,>ênC옔WL>Õ}8Ñ•[‹9þ ØŠžºë¿žÜ …+dJ‹þuŠûÜß„LÇ%…un‘ƒgyñ=ô,~‡»ñ}îÆoBæg‹r½Öš=Ÿâ{è!X|ÔݸpQíÔÅÄ)qEø£»Q(¼£Ôähû’<*v7™U˜<Ù2©þ:Å}îÆ‡˜mCtñK‡'§øz¿ÃÝø6wÓÊMÈ4ÜáWÔaÑJ<žâ*ô,¶ÿþY"/öHI`‡Ï¾z¹¼X0–‚M¾­¥îú¯'×Z%R2òò‡ÿuŠ÷ç½wŠuLíµ^qrŠï¡G`1~ɯ`ñþ¼÷Nñ6±a,o—¥Mt7«ÐC°ø¨»i.‚DÃf›š(3¯ùÅ+·E»©E”“³õuŸzÉæEìmS(ız2›©Ãñw›$=U£Ö}î¦þ1 –(§]*ȦÉ)¾‡žÅúî¦îs7õ&dp,.R{äç[âUè!X|ÔÝUQ~ÍMKÆ&yѱ†Y;–Z¿†{¦âÉÐ ´.…ëš5úuŠûÜM&6àŠ+¶ËÕɶ°Uè!XüwS÷¹›:+3¼\‚ŒÉ)¾‡‚ÅGÝa\‚¢¿eÜ÷'ó"ªÌ@:¿¦žÂâõä¨ç¹’¹³,®~â>wSoB¦âu)+ f§øz¿ÃÝÔ}î¦|UX¢-š¿QßCÁâ£îF[¯ŠõfÕ1£›Ë‹6ÒɽĊ1¦x ´õ2Ž_§¸ÏÝÔa@L qejßðUè!XüwS÷¹›:–GE'/.jãYw³ =‹º,ŠªUº¢"ËÈØÆ>&…¨aŒçòbÅEèXäGÝM¼4šŽ‚›y’w«âŒ»ž£aLæE¬ý…›$­9Ý ïs7<†å)C?S/BÏÀ"‡»á}î†oB†¸ŠÆö®:É‹‹ÐC°ø¨»kfuªIµ ìµ{¤VÂÎÂd^ŒÌã]›@hÄâ>wÃÀ8*iÆŠ•ÓS|=‹ßánxŸ»á[LSj%Á–Z.2áQ¡‡`ñQw Q±ž¾JëTvÃÈ‹íZQÕ»ÄßÚåUœãQ…X¢Tš“SºÞçnø&d¢w`­fØ=¹ÓX„‚Åïp7¼ÏÝðÓDóà@W‹ô19Å÷ÐC°ø¬»!ìÃ0‹´¦XOŸÊ‹æ^:†‰ËEv$yT8÷ªÍà|³¼MùuŠûÜ B&ºR%ÇP[â{è!XüwÃûÜ A¨¨ÞJÓÁðëäßCÁâ³î¦ÕøÞÅ·O¦7Iµ[äUqhh²÷‹°9V¬SoÑ4¦¸Þçnx2æ=rüG›ÍL-BÁâw¸Þçnd2UœZ­L¸›EèX”GÝ (Lr¨´‹WIò¨ÑÇ7¶ø-ɼO&ïEJ4h¾fþ}вÏÝÈ„ŠN¾°›±ÎÔS‹Ð3°(ßándŸ»‘›‘hzC_EgÍUè!X|ÔÝXT¦*(À$™©7a¤p—¯'vxÄ{K”R3S²ÏÝÁw´Ã‘†£f™yl,BÁâw¸Ùçndˆiº8&ìàt6Ãâ{è!X|ÔÝXÇnšx‡ A­ þöØèõ:<£oLÞ/Æ“­`ŸFÁ–µ\^ÜçnDï’Å!ðql¸›©§¡‡`ñ;Üìs7r2µ;–Ò³ƒjœœâ{è!X|ÔÝDqPR¹ëÏ^âŒÇ†Ä_%N-n*/Æ“¥7lWë^J‹ûÜŒÅßVeÅmñäßCÁâw¸Ùçnd,þî˜ÒSìÐ¥ÉäÛ"ô,>ênPQò:*E*ù¼¨—žËTsy9=j¯E­¥f¦dŸ»‘AÈ0þ ƒ·fnz¿ÃÝÈ>w£7!£ƒ²ÍsÂϧ¸=‹ú¨»‰×G€ë8^"Ù9 ÌO“(ªºd¿OnXiìXÿ›ódÔ}îF‡˜Æ¢ƒèÏ›äÅEèXÔïp7ºÏÝè0±‰" ²«î&7S‹ÐC°ø¨»é0áÇ.ÒÈè”YÛvyøÃn8ÚÍGäÇ”O6oj°Ù¨ÚR3SºÏÝè0 †«¶®ºÚD±±=‹ßántŸ»Ñ±øÛ@m|’f÷‹‹ÐC°ø¨»é„$EZÃN\^ŒŽê²slÑÁÕ‹øIäÅKVLôÃÊýøuŠûÜŽA¨nEótÃ"ô,~‡»Ñ}îFÇâïøº©*q3½QßCÁâ£î¦3.$ÔÝ‘ R5jù‡5`•ÍjKÝõ_OŽW¥V+UÏaqŸ»Ñ!¦‘FÅq@°É)¾‡‚Åïp7ºÏÝèÓ°5rî¬u¦G]„‚ÅGÝMÿ{ÔˆZ¸eÖ™^yQºÍÖJtX%›dôÔµx‘œßîs7z2p<-p!Ž·ÇDá¿=‹ßántŸ»±abÓ¤‹V,Ì&ß¡g`Ñu7‚8¤29eVb\y5ª\*#õžíU\:36’3X´}îÆ!M|¤ðÖâU9;Å÷Ð3°hßánlŸ»±?Ë£J¤¹Ê*¤“Nczu7½ÕBÝÁV´¾v)ýáU±ƒ¢&×t^,ÎŽn\8‡Å}îÆþ,j½×"Ulæ=µ=‹ßánlŸ»±±<Š;.Àªv™Ý/.BÁâ£î¦C]"œ“ÒÀÁV‘uf­™1éÞâÞZ÷V·ÔÌ”ís76¡¬v¢˜ÁONñ=ô,~‡»±}îÆnB†#uÆ‚šÎüQ¡‡`ñQw¿q@¢ 6jvç›U'ÆØ„Y¤‘¤o8ì+)Þ]ŒKʜdžís76 ˆ;¦ÂZü–ì³7ê{è!XüwcûÜÝ„Œ9A.–.ϧøzu7˜¹4ÖªÜ)9§a"pWiÕ¯!L^Œ'æªñÝOÎÛ>wc–GaÁdñøßd£.BÁâw¸ÛçnÚ„Bß#oÀkþù¡g`±=ên¢Çn-Z#j^×›×þÊ‹0êDŰj*…ÅëÉñm,Gúi9 \ÛçnÚ=ERŠwlluŸ¼Q¡g`±}‡»iûÜM» ™â-Þûâ¨Y& Ü"ô,>ën"™G×x°Êž¼_Œt(ÆÂ(×’›%¾žÜ.6q¡â) \ÛçnÚŸA(ªŠá‹¦4Ql,BÁâw¸›¶ÏÝ´BÆK…‹ dÌä“êfzŸu7UX´ sRwÓÿ{•‹û¡”÷Ôõdv\oFZ¶–ªQÛ>wÓþ˜Ø¼ »ÂÎÇÉ)¾‡‚Åïp7mŸ»iƒQ¤>fKi2ù¶=‹Ïº›ÞLJ@¸·ìýâ5ñ¤Ð¨·œîz22"©CkÒ£¶}î¦ý1 î‚}ZQÏ‹ÐC°øî¦ís7­ß#4RÍY1¯?Ûù¶=‹º^±j”‹Ú9Òc2/::Æc‡'lrN#žLÑ.Jü ž),îs7í^Åñ”îÌñÚ™ö‹ï¡‡`ñ;ÜMÛçnúMÈH´4%:ùè¨fÆ"ô ,öGÝ›¸Y«wc•KΕ£ïxù@§’¼_Œ'Ã¥®ŽTÖ›<þ}Š}Ÿ»é·˜¦p©ñß#‡×¾=‹ý;ÜMßçn:ÝM ›TŠ86+NNñ=ô,>ênü˜ôZÜêŒ-åjGß֢ݴ¤?êµu„WZj¯)mxßçnúMÈ´bñ;rÆ¥ÍNñ=ô,~‡»éûÜM&6…Z|YZ¼¼ë„G]„‚ÅGÝ‹VÜÕ7Šf7ß/*Œ®¼ös-‘É‹‚Œ\±¢JTSw}Ÿ»é7!Ó¹bÄÛ¢ œžâ{è!XüwÓ÷¹›> ˆ¥á¿G‡± çS|=‹ºW(L$ 2Žî/y¿å\‡:EŽžÝ¿è¤_f7&¼Þüøë÷¹›>Ä4Ü FµÇëcrŠï¡‡`ñ;ÜMßçnzÆQ~¹sav`ñQwƒÉüho¹³–¤Õ¼C)Í"{ç¤î&žüsÕÚžr5ê>wÓo1M·8“ÆuºÛfz¿ÃÝô}îÆ‡‰ µBê39ÅEèXôGÝ3KgÒ¦UkIq7‘™0îù ã)É=SñdRe8êúÔý¢ïs7> ˆ‹lÊ;¬ù'§øzý;Üïs7> ˆ«ï Ò&§øzu7ÑEf¬§Aó—ì uíe Ó~HØL^äèR‹Å*WOiÃ}Ÿ»ñ±ø[¼I/ ~m¢d\„‚Åïp7¾ÏÝø„ª\¨âò­ë ‹ï¡‡`ñQw7nÖ‹ÖÖÖ›×þÒ£³±;üš"C&ób$Ÿ^ {ÅxKª_ô}îÆu %2îAk‰ês–ßCÁâw¸ßçn|2Z掞hrŠï¡‡`ñQwu˜70™¿znç[ùGìZh b“KÖ7 u"7öÞ™kNêûÜBÆ$^9Ò­*Of¦¡‡`ñ;Üïs7~2Qnöh¦ìšF˜œâ{è!X|ÖÝÀ¥‡º‹›š%u7t™ÝcK KËylàÉ-¾îÈ©‘^ss¾Ïݸa[€« PÜi,BÁâw¸ßæn¢…¿ ¥¬7n])²Çó)®BÀbÿïŸå•[¡nê¨15çúŸàYUáÞ_-J\`Q2º÷(åá<Þ6\¯þuŠ÷ç½wŠ·˜æZ« RT¼?3p«Ð#°¿äW°xÞ{§x20¹ç(Åš>+6V¡‡`ñQwƒÊ¥ÇoÞ ¶º"&gûtŠâ(È›4J“’÷‹µ`åÛå"çª}õä_§¸ÍÝô2Ll¬Ç߇3¹ë_…‚ÅÏp7÷ç½wŠƒ$¥wãÉþÅUè!X|ÔÝ È$/`‚/[‹ÿùG[Ô¦X¼ŽË¢–ô«ø¡HäèW-‡ÅmAÈ©T¢Å'¸Uè!Xü wsÞ{§8¡ši—R‰ ϰøzu7µ²b9=·Z~6u'ò"†ß®ŒñÕ•l¿ˆ'“D¨ Æá),ns7½üYüm˜f# Z>ó¨«ÐC°øîæþ¼÷Nñ„‚ªG'_°…wrŠï¡‡`ñQwï òÒ]Ð㦰ˆf3º*3«ð ÊyOýÅEèX¬º›HN‹`ÿ™Ë‹‘ÎàÁo°…%J\NòýäR•=ðÕ}‹uŸ»©7!ƒõ& |ñ‹>Ÿâ{èX¬ßánê>wS‡˜¦A.`VbrŠï¡‡`ñQwƒ5 ­b$ƒKRšÈ‹DôŠNñŠÄšÁâÏ“áuÌÑšý$Õ},îs7•oa›B9KŒÙ®ßCÁâw¸›ºÏÝÔ›1g¨=à¤ÓX„‚ÅGÝMe7´Ñ¿µZ6/BUNÖwSÇ ÈLÜÕ'÷‹‹ÐC°øî¦îs7t2Qu6U¡‰nzéQwsŒ¨©cáÔ¥ ÍäÅèø\Zd¸HŒ=!ÚáŸ'Çw½y|\Ý$…EÚçnhˆi¢fi ÛIšl […žEúwCûÜ ÑŸÂÓjœL¯Û¤ë_„‚ÅgÝEËǵžK6óï~±µVD"£ [ ƒï'õ/¸§°¸ÏÝÐ0±i$-R?¶[=ÏL­BÁâw¸Úçnè6 Æ2ylq£Z™œâ{è!X|ÖÝ2“TÜLÔ5ƒòW^,fQ (¾ºš»Óøyòµ1)ºÌÈ¿NqŸ»¡[Lƒüß°€'Òøä~qz¿ÃÝÐ>wCcªcJßaÉ[fX|=‹ÏºCèL öevúËc#ʃäbjOî™Â“ãç0òé–Äâ>wCí–íS)µŠw§é)¾‡‚Åïp7´ÏÝÐ='ÏñeeÂR¥É)¾‡‚ÅgÝM+ÚJU°†m­Dûkf Ê[ú´6KyÿwÃ7!Ó®kCª‘Ègê©EèXäïp7¼ÏÝðMÈP¼óÎ.QÃMºþEè!X|ÖÝ@?©7KÞi¨:i•è÷€©¤?jwÃ7!ƒŠ c09=;Å÷ÐC°øî†÷¹bëØ8ÁÌ2ëú¡‡`ñYwcX¤_¾€D—$wS±Y<ÊSãâ˜iHò¨XK^âÉQêæîúyŸ»á[LS0FÑ×vM¾-BÁâw¸Þçnø&dpù« £»™œâ{è!X|Öݘ4…®%rºÜõ,\‰ãOÌ’XÞÈ÷“™1¡T UJaqŸ»á!¦)ÄÞÑ‹OÔS‹ÐC°øî†÷¹¹ 0ÛÔK‰þ¦Lt7‹Ð3°(Ý’xÔÖ‘JöN®"µ¬¹Ëën”ª[kÚ¨¯?ÿ>EÙçnä&dÔõêOaÏ?É‹‹Ð3°(ßándŸ»‘ÿ"d\zUµ2cࡇ`ñYwÓ}ÞUŒ$Ù/RU&äF‹gçãÉÑ/¦Û~\’÷±¸ÏÝÈ=%p-`Ì•èÄnz¿ÃÝÈ>w#7!ƒßM.õ䬺Y„‚ÅgÝM|(ÜQ©öõ-ß_ÞSZ£¼-îXÝXS5ê®3ë‘ãíÕ{êNCö¹Ñûh×™¤ó}«ÐC°øîFö¹¹ "ùQ/KåßCÁâ³î&êS‹©8öj$g‰ ›µ¢p“Z(53õód,sФªZsyqŸ»‘1U° ]£5-}Òõ/BÁâw¸Ùçn¤ÿÖ¢¨°]ž…ϧøzŸu7Ù\ˆ£Õ²d^İ&Ìÿ#7vÕ„Ñ1ßOV¨["¯úú-ðë÷¹¹ (à%úÓ(A'§øz¿ÃÝÈ>w£cy¾hñ‹œJîfzõYwã0TŒ?„µÒ(93ÅÕ”£´FÔ—ÖßçE.µCSï©; Ýçnt,ê­%Mg ÿEèXÔïp7ºÏÝèMÈ0k|Õ`FTfJÆEè!X|Öݸ•Ö4hViY)þ•¯ý‰b½Q­’òØøy2sô™r]饰¸ÏÝè-¦Á†H¼9°Ã}£.BÁâw¸Ýçnt˜Øp\ýz¼ù']ÿ"ô,>ën"«©s«µqRïžÀ ÕRðJÕ¨?O—бOH3XÜçnt,þvAž3ì›èn¡‡`ñ;Üîs7úÇĦD&Plμ§¡‡`ñYwƒ .ÂJÎ÷ØS&/øSìáhˆgyTñÒ˜¤S)-Õ/ê>w£m4 c›£§5ê{è!Xüw£ûÜÞ„ ÷xëSc ³~ñ=ô,>ënZ‡uÜ]Š),F^D‘Ù`Ïaн¡ÉûÅÎñ³‘W rr ‹ûÜÞ„LmŒ7Ž2V¯NNñ=ô,~‡»Ñ}îÆ!ƒ8— hï“~qzm¢»Át%Á–ŠõDï_÷‹Q™Rq¼z,^CYÝMTñcÞq…°tƒü÷)Ú>wcÀX¡ rõJe‚ÅEèX´ïp7¶ÏÝ yb´C­›GÞ˜t‹ÐC°8ñ»³iU¢V´'=6ˆaUÓ0Ø›¤°øóä€?î½ä<mŸ»±1uÍ^4«:u_„‚Åïp7¶ÏÝØMÈÔ(¿<Ê©F<Û§±=‹3¿›hr«EbŒr3«GuµZL:Dœ=åÉx=Ù$ªÜJwc7!sím—V¥ÆéLNñ=ô,~‡»±}îÆ†±:y$j<ó»Y„‚ÅgÝyq$'*k—Ò¿ò"dXئÿˆwóód2¬Ô(Ei©JÿuŠûÜÝ„ G5Œ‰Äî\gÕÍ{è!XüwcûÜM» X+YÑÒ/o¦ÇS\„žÅö¬»ÁŒD£Š™KÉÞ/ªÇ¶w1b¯’òžúyrÔ¶Ô‰˜s{¦Ú>wÓÆ TüPóN ™â{èXlßánÚ>wÓÆ T|M ˬû” _„‚ÅgÝMä4cLæ[ä¨Á£FyÙÕÄâ_5å±q=™#ó(Vúš5úuŠûÜM„ a$¤¡,“êfz¿ÃÝ´}î¦Ý„ ]~`]`t8“S|=‹ÏºÃþÕfå–õØhð€³Ë2-ÒúEIõ‹ZZ‹âYJ×ö¹›6ÃÉ5Þ:Vã;9Å÷ÐC°øî¦ís7m2Š=ÑÆËr†/BÁâÄƒOQg–䆰r Š%š¬Ÿõ4©¼ˆ•ÈÑ*Âw­¤¸›¶ÏÝ´Û€˜±ËíòÊâÙ\ÿ"ô,~‡»iûÜMb#)½ÃDnöF}=‹¿›fYQÉý‹ uWã¼oøµ†û²]KæÅ}î¦Ý„ÌuÚ Øk3…ÿ"ô,~‡»iûÜM¿ ˆ„I©ƒ_›t‹Ð3°Ø'ºŒJ™¸K¤¶¤®^Æ>Ž9±ªé½Ä‘ …<šk­ê)ÝMßçnúXEñž„üM‹Ð3°Ø¿ÃÝô}î¦ß„L¼«ãòÞÜ'5ê"ô,Nt7 ODødc½Evÿb@°]óVðÎÞ/r're•¢9 \ßçnú„òø*˜*™y/BÁâw¸›¾ÏÝôa@ܸ´¼1œœâ{è!X|ÖÝhäDü¬DvJzOÁƒÒ²òZœ³ó‹ñdì|S¡êšâQû>wÓÿ˜ØD5íZ¢»æÅ÷ÐC°øî¦ïs7ÝÆ€pl.\}Òi,BÁâ³îF½ôÊDÑùõõû_wU;T;QÜÂd5™õg#r¤cŽ‚"…Å}î¦ßbši‹[»¡~>Å÷ÐC°øî¦ïs7}˜ØH”R0AipHz>Å÷ÐC°ø¬»Ñ¨NK±h‹´¬'#VMV-…-0Y²yÑ+|Ƚ&ûÅ}î¦B†ÍX¢Ágκþ÷ÐC°øî¦ïs7~2M îØÛ;Ûm³=‹þ¬»QëÑïõ†¨ù»~Žü!ZY±9›áSŒý¿0±LÍ/ú>wã7!c‘é(€ÓI¿¸=‹þîÆ÷¹‹¿#o`[4Ì &º›Eè!X|ÖÝ`|ƒÀ)Îî|£nä%R£Uó´ßöÚ¸V¬ä(–ªQ}Ÿ»q‚oE‡â¯œI׿=‹ßán|Ÿ»ñ›‰Š¶Ú0Xšy/BÁâ³îF£á3ñg×”?jäE·ÀÓÕob¸?›]ªG‹]¥»§îú}Ÿ»q»¦õ16ͳ7ê{è!XüwãûÜbPÜ.å:›ÓX„‚ʼnî‹ÓÓùQ4d½§ Ü}ÐnF™š«Qn6¹ÀÔ‘Hk®FÝçnü&d Öã¢QO{p7‹ÐC°øîÆ÷¹bš(£:Ì#ÌúÅ÷ÐC°8ÑÝ`i*E‘¢É~1¾±&\~¸ævÛ\O†IØŸB¹½Ä¾ÏݸßcÞTa ™°á‹ÐC°øîÆ·¹/7!C­©F_Ap<žâ*ô,úÿ,òb§×nzîÅ’<*£ŠŽ"“$wÛ\Ož¬’@F—Àâýyïâ„jN,ØNG“;UèXŒ_ò+X¼?ï½Sü!dâ»bFÍ¢Õ´‰6|zŸu7Ê5¦Å·O8·1úÅ^"¥JTš…jOó¨Œ}Äñ‘E™Z2w÷ç½wŠ7!cÑÆCŒîvvŠï¡‡`ñ3ÜÍýyï¢ÜGƒûh´6†áùßCÁâDw£pUI²ý"5ê˜|¢k†1Û/F>ŽŸl Îyɼ¸ÍÝx¹Å4(Z`ã ;ØgÝÍ*ô,~†»¹?ï½S¼ ™FDZ¤TÖI׿ =‹Ý $¥5~i)–ó»¹f‰íBc|{{nGøõddbmElÆcãþ¼÷Nñ&d *ˆô éþDá¿ =‹ŸánîÏ{ï!c0u'éu¦*^…‚ÅgÝtí¥,j£´îFé2G¥ÞkVwWÕ†1‹·A†»¹?ï½Sbš‚²Ó‘Åˬºy=‹ŸánîÏ{ëë dˆ"ÏyÃ:¤çûÅUèX¬Ïº‘n½qdÇøí³y[|š 7ï^³yQ¤EaKRŠ2gîúïÏ{ïÇò¨ò3ÒK-Ï<ê*ô ,Öïp7uŸ»©ÃÄ×Ù¢jŽÚϧøzŸu7°Ð/@$®û“žŒ°ŸÄž©FÑ_åf¦ðd…@ ”Š¥ÌœÆýyïâ7ÕõôäßCÁâw¸›ºÏÝÔ[L£›4®µèDw³ =‹Ïº!U‰4ÞðÉoÄx EZÍÎ/ t‘1¿(™½Ä÷ç½wŠ·˜%¿eiu²—xz¿ÃÝÔ}åQÞ \’ ß“S|=‹Ïºö‚2׌%;×O¥ã« ³áôž)î½XÊ^·“),îs7õ&dL.¿ñ^Ý&ŠUè!XüwS÷¹›ÚÇð†m£}¨6™ë_…‚ÅgÝ [5¡ÑùéÚu毹þè­¼ aÖ>«»a+Ñhz‰ä¸¡¾ûuŠûÜM½ ™¦­¾”~<áQ¡‡`ñ;ÜMÝçn¨Üwä‹ndÅhâ8½ =‹ô¬»‰ÂÔ£»R”¥jT\Â9œk~<Sý"Æ“¢(âñ Ë`‘ö¹ƒPñ‹¿J/³»þEèX¤ïp7´ÏÝÐMÈÄ7%ªÎ=U›õ‹‹ÐC°ø¬»Á¾5¾¶/FFÏæÅQÓÀl=;×ÿóYµÈ«ÔwC7!SÈׂþt†Å÷ÐC°øî†ö¹Ë£¨F HŽ]Ó»þEè!X|ÖÝ0šÜÂnŽuOIÔάÑY1æ/î&ão±Þ ŒÐÔÌÔýyïâ0 f¿Ü3¨Ïި`ñ;Ü ís7ôCÈ4/X‘µçÉ·Uè!X|Öݰª g÷/R…6n¯ ‘Œo8Ä×âph-µñþ¼÷Nq,*Q‰ÜüFŸ:9Å÷ÐC°øî†ö¹êc('ÃÍ›Ïîú¡‡`ñYw¦2úܶ³yí÷)’äÝ…ão3y1@Xá:U´‘äjÔ}î†nBFDE‰F¢Íª›÷ÐC°øî†ö¹Ë£8ʨ-Òdÿâ*ô ,ò³î†¬FÛ×£EŠ7Iª_üÏ?Ž0ñíŠ÷Ë>*ãNЙEZ%Žz0³ õþ¼÷N±Ž |º(ÕgÕÍ"ô ,òw¸Þçnx˜ØˆUøbCæ5¹™Z„‚ÅgÝM$µR™T¾õIî†;wÃ7!#ÔÌ£ŽŠž~úF}=‹Ïº›*ª þ²wØmÏ>ÞŽI5:ëÈÊQ¨Vܪ§°¸ÏÝðÓƒÉá¿LNñ=ô,~‡»á}î†Çò¨Ö‘1pÿÖgoÔ÷ÐC°ø¬»©Ñ 9{oìbÙYâ*½DÙ:WªÙ½ÄžÀ?°æ–šÓà}î†Û|{@_™ñä–xz¿ÃÝð>wÃáfÚ„ éd[Ø*ô,>ën"¡¹t©Bð?KÏL)þÌ.r–š™ºžÜ/†„ᲑºÓà}˜F|š™ûìúz¿ÃÝð>w#å6Έÿñ‹öo“}«Ð3°(Ϻ›ýšY¹^ šÍ‹ÆŒ| CXól¿ £Gظ2{*/Ê>w#7!ƒíñ¶!ÃÎ×É)¾‡žEùw#ûÜÐÖ×xGV8ä¶ÉÆ"ô,>ënŠ_³³,ñ·–ìÉz¤¶HjâQ­fçÑ1À™Ðk¦ündŸ»‘›ñEtÇœ–ñ$/.BÁâw¸Ùçnä&dŠX4€V0”0án¡‡`ñYwƒû¼<àãŸÞmã˜AÆžï¦SÜÍõä(NkÃ=^é©»~ÙçnD‡qGeÃ>Ùô¾ =‹ßándŸ»‘›©Ö ^¾ÑUMóâ{è!X|ÖÝEeݤqvfŠkõÒ°ÝžêÏh~&/R¬Z°ˆ;àœË‹ûÜÜb±Íi£™íB]…‚Åïp7²ÏÝÈ0±‰—‰–ÊÚOèÓ)¾‡‚ʼnî†+´3V[³œ®M¸¨÷襤<ü¯'—"zÝiΓQö¹¹ ™8™è‹¡Ol2ц/BÁâw¸ÙçnôÓ(“{s+p}>ÅEèXÔ™î†.KR]"⯼HðHo:.Ù¹~2ŠÔ9½§æúuŸ»Ñ› d©‚'*J“Nczõ;Üîs7úgy”5ÇéÈ” _„‚ʼnî¦Õènâ5RZÒ{ŠIa™OÓ(7³ý"(®è£ÝÌÍ/ê>w£ƒáÞk1…1Ï$/.BÁâw¸Ýçnô&d(ª(ÜÂTjöF}=‹ÏºlýdˆÐz$ôäœsTãŠ#zMÎú†s”ô…+;¼USwºÏÝèXü]¤Æ±`±â4/¾‡‚Åïp7ºÏÝèB†*n~ &0&§øzŸu7‚3bL‘³;ßøZjj±¨2³º›(‰/·R¨¬«ã_§¸ÏÝè0±)ðUf‰Z¼L¸Eè!Xüw£ûÜÞ„L”5 Oߨ`ñYw9 ·e齿;“£D…Ïe3Læçú»Ç¿‹ì«JaqŸ»Ñ›±8“^j‚Ef§øz¿ÃÝè>wc7!#R,ʨêÎ<™|[„žE{ÖÝH|ñ8:]ÆoŸíá[—Ÿh5­¥ýn¤^륚”TjûÜý„b¬Â¤ÍNñ=ô ,Úw¸Ûçnì&dÌ;ò){¯S,¾‡‚ʼnßM+Ña&Á´'=68’H´}X_Ûìý¢à66¾ðÑ­ZMÍiØ>wc<„ã1M!šù†/BÁâw¸Ûçnl˜Ø”è©vŽÎj¢ØX„‚ÅÉž©€`dÅÒkÇà¿u7Zà](ì¬=»OCÅg¹uFþuŠûÜé ÕP|j+PúLNñ=ô,~‡»±}îÆÆâohÚ¨  šuý‹ÐC°ø¬»¹¶ 6 4¹×¬‡C»ÇJŠÕ8©õz2úM,ÿÅ8r ‹ûÜÅ߸ªÂ­TŸañ=ô,~‡»±}îÆ!CD(W¢n™m(Z„‚ÅgÝMÂúJ­1sÏêQ©á¢Þ£4gº†<2y±Ue†BücÖt¿NqŸ»±1U¢šŽ\§4õ _„‚Åïp7¶ÏÝ´›) 7plÇl³êfzÛ³î&`½"’£öš¼_¬pª*µ`y[ö~\¥Ã¿¿s]O1ÿûÛ>wÓ†q>°3vLÎ4p‹Ð3°Ø¾ÃÝ´}î¦åQ/¯0,ôé)¾‡‚ÅgÝMô‰Ñ·ÅkÄswý(3Õâû*ÌQ¤JVwÓÕ)zUXvinN£ís7íÏ T)‘ø{»†žŸOñ=ô,~‡»iûÜMbe3Á—­Ì&ß¡‡`ñYwãXàÊT©F‰šì«hTýìÐE—•Ì‹Î"Í&Ìr;ßÚ>wÓîA¨ÈþÚ °6Ûù¶=‹ßánÚ>wÓlžñŠ”8sš½QßCÁâ³îæòºbk‘å²>pT¨Q‹÷Oi,ÙûÅø¶K8‘–(”SXÜçnÚXü}Y“‰•ÙηEè!XüwÓö¹›v2Ñq÷?j³]¨‹ÐC°ø¬»ñŽ÷ø…£XÌîB­P¯U,¸3²Ün<¹9uÇp’G·šÂâ>wÓ†1Ç¡P7Ò)w³=‹ßánÚ>wÓoB¦c²'rFd€:QO-BÏÀbÖÝÄÛ"“CÌV²sýpIG‰X,?;Â3¾á°#á¨1ÜRXìûÜM¿ ÅÂlÅi^'ŠEèXìßánú>wÓÇò¨‚M¡ ™ÈlÃ"ô,>ën¼U…ÍE‡³kÊÃÿ?ÿt¨Ññ9ÁV‘“¾ánØK.tmÉKiÃû>wÓoB~§ð‘xyÌNñ=ô,~‡»éûÜMÿCÈÄ+²)-LNñ=ô,>ënâ#‘@aüò-þ ¹¼Ø5f|q-Rkñl^ì¥c:Dº—õæÇ_§¸ÏÝô›‰Ê3*ÎÈÃ]i†/BÁâw¸›¾ÏÝtà Ë1[+¬%ã"ô,>ën\šr±BbT’>p¦‚µVÔ¹^ãÀ©¼(‰Õõ*S¸¾ÏÝô›AöïÅ£3噳æ"ô,~‡»éûÜM¿ ™ZaÊïR(RÈäßCÁâ³î&*Å(Ê*AW’þ¨Ãjl‚­Ä?bÖT^4íð8vF^MaqŸ»é~SÜfõpœNŸÍi,BÁâw¸›¾ÏÝø„Rõ"%Ž'RÈó).BÏÀ¢?ën®˜z¨ÄIU{ÅϪs’wóÓ©6õøw|ýs^žÏÝø d¢œŽbÅTyÖ/.BÏÀ¢‡»ñ}îÆ!ÓÎÚñò×:©Q¡‡`ñYwÞ¥R­,ÍsþåeU˜úF{\‰(›©ã‡ñHñ¨¾ÏÝøMÈhõ$—HáeRÝ,BÁâw¸ßçn|±Hv Qͤë_„‚ʼnî¦V\ö+FŸÖÛž~çE‰Ü™]ØjMíBÅ“Kï¹(–Œ§xTßçn|˜Ø˜pÀž v€MNñ=ô,~‡»ñ}îÆoBæÚ¿$²ø¾Íª›÷ÐC°8ÑÝP±HNŠ)ÄwSþìPÄN dJíBÅ“k8¹Ç7^r>p¾ÏÝøXü YQ@¬ôvϧøz¿ÃÝø>wãÀ˜¬aýWòÁÉ)¾‡‚ÅgÝMox0–œqz®Ÿ{à8P,_ß–Ì‹vñˆšÐZ‹ûÜßbØú CŒ1ë4ÞCÁâw¸ßånjüû–DÅ—ÅL+ECÿˆÅeè XÄ/ù˜»›q4¸­ (Kï™ÂRô¨o™+¥°x=HÄšÃV3zÔñyïâ2˜õî¼=bqzñK~‹ãóÞ;Åa@¬ñqÑŽMÚ“S|=‹Ïºø*w%Áª³ÜÆþ¡BBµh$Æf={¿ØáäI¸<È`q—»‰Ð±ënà‹ÚQlF‹Ô“{¦ÓNU:6¢öšân®'+²*ŒŠy­JÿuŠ»ÜM„þ1 n˜ Vƒ¶arŠï¡‡`ñ+ÜÍø¼÷Nq˜Ø˜2¬µ906{£¾‡‚ÅgÝMüÎåîW®ëJñ¯¼(Ð’bíÊÜTz=¹þhè°8¡GŸ÷Þ)Þ„ŒF%Þ­c ³?ên–¡‡`ñ+ÜÍø¼·N±Þbš¯a$:£¦“S\„žÅú¬»œHtm:¥°øŸ ›Ñ¨oÕ [Qã‡%‘õºÅ«Ñ™E¡š˜ëŸ÷Þ)Þ„Ltñ¢ñ†,•lÒõ/BÏÀbýwS÷¹›: ˆÑÁC´Í°øzŸu7¢ÖÙ‰:7[ßòý¥»qñ¨R)þ¼Òªg°x=9Êâ(=³#||Þ{§8Ä4×4ˆ[¼=žç4–¡‡`ñ;ÜMÝçnêMÈW®µö(YžþËÐC°8Ù3Õ°Ô"ŠM“*Éý‹½D`" —SMañz2ôo,ÇøØRXÜçnê d4€E½ÁÙcÒi,BÁâw¸›ºÏÝÔ!¦aTžd^Ÿp7‹ÐC°ø¬»ac¸ ×KŒ–œÓ£hƒå½·ìœGcÍb'HSwuŸ»©Ã€Ø£-uwdyžë_†‚Åïp7uŸ»©7!£‘ïzéYOfyñ=ô,>ën«5ÒyoºÞ0ó—ßH»<+V gï¹Â¡9“l¨ ~â>wS‡‰MóZ„ êÙ)¾‡‚Åïp7uŸ»¡›¹.œ*îëóV”eèX¤gÝ µªè‘¸÷d¿Hâñ›µæù9x ÄÇ5„–³ÄãóÞ;Åa@,«—ão‘È'§øzé;Ü ís7t2ñ’tƒï ^—“S|=‹ÏºÂ/ÌâµÕÚ’y+¢´ãR5*\Jyl\OfìãêØÊøÝŒÏ{ïoB†zEþ.?ŽÌϧøz¿ÃÝÐ>wC7!£Þ«Ç7<ÅDº=‹ÏºÂm?/K”×IÝ ÷VìMcSvNƒ°S-^JØË•Ââ>wC7!cä˜{ŒOߨ`ñ;Ü ís7ôgy”*"ZôyçÛ2ô,>ënà5£]øÒß$yÔh¹ªãÚ–+¥¸›ëÉQÆGÅTŠåòâ>wCƒÁ5‹G}œ_\†‚Åïp7´ÏÝÐ0±¡hæá O—É)¾‡‚ÅgÝ )&õŒ‹á=9¿ûÉ1u$ÕžõG%E6íͼêºSýuŠûÜ Ý„ H¢î‚Õ¯3õÔ"ô,~‡»¡}î†Ëa۵‡óèɸ =‹ü¬»¡è¼â/ëë­õ‹QÖb…H…¿OIçÅJ¢-êÜÇü yŸ»áAÈD“ <$'5ê"ô ,òw¸Þçn˜Æ°>6~F§iåÙý}zŸu7×& "-ØÅ›ô çz$RþV²zTb‚ ‚`g%¥xTÞçnx BµÝ)ÃMz6ù¶=‹ßánxŸ»a¹¯›ÜÅã Î ›œâ{è!X|ÖÝôo_¿ÆžÕÝ0.‰äXëcÙ¼Ø{Cbà+sXÜçnx2ñ~ŒÚ–*ë³ãô2ô,~‡»á}˜¯|d2_„‚ʼn?J J×læ_yÑÍ`ÓŠ–š›™Â“£Ë‹&[»{ü:Å}1«Æ@{vJY†‚Åïp7¼ÏÝðMÈ\Wáv­D›q7‹ÐC°8ÑÝÀ¹N"/F››%þÏ?*X5éMªÅ¿ÒºxÈE>e«=ã:>ï½SĆ • •Y^|=‹ßánxŸ»‘a@|íüÆÒ?ñI^\„žEyÖÝEu ®Å„³û4Ô#‹ÄO–^UR5êõäk _T¸ÚÊ`Qö¹©CØŒAÒ€Èϧøzå;Üìs72¡¢™ŠæÁŒêóþÅeè!X|Ö݈I·ø! -ITtnN\zw-×]fÿ¢X©îÊ5Ú2ÍaqŸ»‘±< ÂÄø]­Ö2aࡇ`ñ;Üìs72–Gq—ÞýL=µ=‹ÏºåÞ+q”Ф=™£Ì4llóHq|Ý/fö+šk¹rP«),îs72 ˆÉ0 ÜLÙ'5ê"ô,~‡»‘}îF†‰c ˜ÇÖúìßCÁâ³î&’“Z¤óHmMRwý?6•pEÈõg…b&/ª›i+ݪ×Ü,±ìs72Ä4=ºâxw@*4aá‡`ñ;Üìs7ÒoË…îXý­pœU7`qæwÃ|yƒXWÎúÝ@ç(˜æ$ó¢E..ÑY LoRºÙçnä&d*Ž«c³Nã=ô,~‡»‘}îFoB†4 ¸&\°æù¡g`QŸu7Å)6b·µcðï¼HpáÇ£aèª%óbýfücÓxª_Ô}îFoB† 3Ï¿ªÏ‹Ð3°¨ßántŸ»Ñ±< I®[«¨Ã&§øzŸu7ñ˲h­ÍnKiàÊ?)µiéîñTŠ'—Ž{ +Í£5KaqŸ»Ñ?bšÂÊ‘î*|‘ŸOñ=ô,~‡»Ñ}îFÇò¨Š‘¦(æúä~qzŸu7-êÌ(ª­b©Eò~‘ E­ªànúÕl¦òbï¸WG¡mv ‹ûÜÞb¯Õš‘Àõn2m³=‹ßántŸ»Ñ1Õ¥·÷Lɸ=‹ÏºøkEÏV`•Ì‹ŽS^±x¢\©-“»`»U©N-yׯûÜÞ„Œnšâ¥ÈÉ)¾‡‚Åïp7ºÏÝè0±±e'Gs3ÓX„‚ÅÉž)‚´»{üöIÿüÃ…¢=®®T¢wcCL¨ï=SPk“S|=‹öîÆö¹£!2UF'H­É¤ºY„‚ÅÉž)2oZ›Âs¸kNƒ¡có&XÍ‹0ÙÀ*U‹Z7•mŸ»±›‰—£`/]¼tl†/BÁâw¸Ûçnì&d°;‡¢¾ÕßCÁâdÏV€ˆôȵ-'—þž_Tø¿I1)YÝMô‹Q öZgä_§¸ÏÝØ0 ŽZœÑÃútrŠï¡‡`ñ;Üís7f£ ¬`ûãõm2«QßCÁâ³î¦›*WWÍêQëÞJ´Œ˜jà¬î¦«7kÑ›aE^‹ûÜý—‰T¬«i]&þ‹ÐC°øîÆö¹û!dwccÊ©¹YW‰brŠï¡‡`ñ;Üís7í&d˜*»_¶eϧ¸=‹íYws-§‰’::$YwmÝ/z5÷(èp—Ó³ýbÔó}u”¨$’Ò†·}î¦Ý„Ls¬˜kd³ E‹Ð3°Ø¾ÃÝ´}î¦ BF4z"˜Gw39Å÷ÐC°ø¬»ñh¥¶F¥5›ù÷ý"̧¢hQeÖ,êÍq£bÌÒ,¥kûÜM„ŒU+˜õžiá‡`ñ;ÜMÛçnÚ d¸ÂðT0ô:¹™Z„‚ÅGÝ EóÕ[‰ìÔ”zº_ÄM\¼zØêÏØS"/Æ“ Äáñ7‰ž1…Å}î¦Ý„L4Åæ~‹3,¾‡‚Åïp7mŸ»i7!ÓáF_5­s,¾‡‚ÅGÝ 4lÑ0j‡QOö~1 [þ*?Ll¦òb<¹t5lÀÎÃ÷¹›v2%R¸Gúí¯Éýâ"ô,~‡»iûÜMbbQL_ž…ϧøzŸu7ß8‡;HÃíBZwcR8z«n¤Ù9 ¸¢²H¼°—+…Å}î¦Ýbšxepo]¢h™¹¿/BÁâw¸›¶ÏÝô!¦éRTéR@ONqzû£î†à<…—°;ëW¹ÚÎÍL]yQTµ®Ü(µ#¼ïs7½Ž‹Š@XÔ,UšNjÔEèXìßánú>wÓ‡±õÐÒîpš>Å÷ÐC°ø¨»‰®M-Ú6ß?U£"/¶†õ6XÅÜ/ËšT¿¨'Á€.°˜êû>wÓùO²Ãÿ°pÍL-BÁâw¸›¾ÏÝô±ø»jëÅ9J9›°á‹ÐC°ø¨»‰¼ØjoEã·¦¬ß yobðe‹æ¯'îXÍ5ÊãÔýbßçnú d°æÑKTÓS6|z¿ÃÝô}î¦ÿYüõ¦ÕºØlÓû"ô,>ên";õÎ׎)8‡gó"›°ôkÉçó"u­„í”ó ïûÜMƒP×¾!D}æþ¾=‹ßánú>wÓ!ƒÉ‹¦ÝÔg<ê"ô,>ên ‘Ô©ôGYÕ„×Ê·šºë¿žÌò3¦ÑZŽ»éûÜM¿ ‚gi4Õ¬ºy=‹ßánú>wãÀXàZˆ[|Í/BÏÀ¢?ên¨Ä7›˜pŸF’ô»a,¶J‘J”[j–øz2EFí\a”š™ò}îÆoB†~æ³È¢þœhà¡g`Ñ¿ÃÝø>wãÀ»_·>Sø/BÁâDwÓ<^!ÅUP/&ób”—Ñ"_‚T7JënàâOU ô),îs7>Ä4ØúÁõx›U7‹ÐC°øîÆ÷¹bín…Õâ+0™ë_„‚ʼnî&2@+?{IK¶_ÄU ¹á¶?­»1–zü/)=ªïs7>y­ [·Y^|=‹ßán|Ÿ»ñ1U, °Q™Íõ/BÁâDwㆵ6Ü£~·ÿ?w·«ËŽ+ b¯â{£$þI| ßø † 4ÐÀ1Ú~~3r¤fÕ˜•J‰¾h¨³jתŸÍ\cÌO_$ÉP0˜Ý¿hh«L±•KšGõr¹–G㨖âQ}Ÿ»ñ›‰ õÞ*wã º=‹ßán|Ÿ»ñ›±&pÕU¦h¨&§øzu73ÅHj®‘Ñ{vÿâe@„ÒÈSÚpüäÒ+6ɸÁÇ2…Å}îÆ‡qÅÂNRfÆ{è!XüwãÛÜM-eØŸ8R]ƒŒùù®zë–W^„ÔÖØ2c”ªQ#/ÂÆL)Þ=½'ýQ/r¤€z §f‰ïÏ{ïë=”XqÚ[£Ÿ±¸ =‹ñK~‹÷ç½wŠCLƒdtDùã9/®BÁâ³î»°k­ A{_2(åÅÞ£Ò¨„­LNY•9êR"þ-åwÞ{§8 ˆ¬ÞÙY'ÜÍ*ô,~†»¹?ï½SË£¢wˆw¤uií¹_\…‚ÅgÝM|á$rÓ¥)íÙ9 Hà0œß¤¦çú 6ÅÝk㦰ÍË`q›»©åÏâoÈ_ÅšêÄ«xz?ÃÝÜŸ÷Þ)1 iƒk`õÙäßCÁâ³î†MšŠß¼¨¦îúÑ/v½N%R[MÍLá'k«U//«õþ¼÷Nq,þnäØP´M¶¢¬BÁâg¸›ûóÞ;Å?‹¿1ݯïh©fýâ{è!X|ÖÝD‰Z$¾wØl“¾_4Ål>Wn5;§ÁÞ3"„»Ì]ÿýyïâ-¦éÖ‡öÖ§“S|=‹ŸánîÏ{ëë⦽¹ œ<ŸOqzë³îFܸZgcåõ†™¿òbã(O cB¥¥ç4$ºÍ.ТIæ®ÿþ¼÷Nñ&dõ.°±ßäßCÏÀbýwS÷¹›J÷k²À¬`ÇàD· =‹º 5,¦~ÏÓzÔh5µ–Z"½Qvÿb¤Có& :[«ï~â>wSù&GÑâÅož ·=‹ßánê>wSoB&’\*¥Y—Ù)¾‡‚ÅgÝM«Za—Å%°˜õ ÷j×6ÑÖ)«»iå’}2üJ./îs7u2õªm+Å/wS‡17µÒãÍ_¸É)¾‡‚ÅgÝ^š2ª©ÂÙûEq¡øL£óëܲºq2ÔÉ~‹ûÜM&6P34jš¦5ê{è!XüwS÷¹ú!d›{›¨îɦ÷UèX¤gÝ waôŠU¥¬oþžÓˆ¦*JMÇeËúÀz£ˆ(ZÎøÝÜŸ÷Þ)ÞƒP5ÞÖD,j–Éuzé;Ü ís7t‹i”¨Bé“ëÉýâ"ô,Nt7Ô8þŸÕ&Kö~±JüI ­U±šÜ§AQÎSqŒyÔœ÷Ôýyïâ0±aŠrwCCLÓ•à ýüäßCÁâLw¿uÃJ%,;ËúÝ ¥²Km¤YTbO˼Ç×>·#üþ¼÷Nqˆi 5wÃCLývFÄ×µMúÅEèXägÝ ¼5º5cÜögýQãïu¹y‰¦¯§jTüäxV5rOÅöØ yŸ»á›ó$VF{Ÿmz_…žEþwÃûÜ Ó¸Àïѱ™×‰ßÍ*ô,>ënàE"išÕ£’›ÄƒYU£<,«„]W‹ûÜ ßbš8y‰,Πd&w‹ÐC°øî†÷¹ƒPÕù‡õ‰oø*ô,>ënÌÁÀ”ªK·l¿XŠ–ÚªY| Ù~1^\Õ*|1ÆœÂâ>wÃcñw)ÑÚJÀ¸µI׿=‹ßánxŸ»á?ƒP­÷ø¾Â|vŠï¡‡`ñYwÓZmyR kŠ»A¿è޼Vâß²ó‹-€¨n0‘š™â}‰ &^ó]³S|=‹ßánxŸ»áAÈx|Ó,J1†äòùßCÁâ³î¦Këpé¡éÙ9 âªZØjÔš’Õ£vn8‡µsJwÃûÜ ßbnÑeVáî¥ÍNñ=ô,~‡»á}îFÊC)mX U­MúÅEèX”gÝM/X`oÑ­oÜÿÖÝÄ›Ëi¢÷«’훓´Ë®S[vªÿyвÏÝÈXåñ'…À( 6é¡g`Q¾ÃÝÈ>w#cñ7Ç¡Xq8ˆ­BÁâ³îæƒdÕkoš«Q¡G-Ìñî bÁM6/Fw#7!ƒ{ìb;Àf]ÿ"ô,>ënz»V®Aá½1ÑûW^ÁáÑc5ól^ìÆŽ·P¯mé@÷ë÷¹bìí@_}²ómz¿ÃÝÈ>w#7!¶ß}M›ùÝ,BÁâ³îƱ52º´¦’½_ŒÞØ#KQ`2þàɼ *YÇœîDRXÜçnä&d„ïe]à:«nÞCÁâw¸Ùçnd2¸;‹W1õ‰uzu7\)z£®ñ"!^;éÿ•áðSŠ(tžÔ£26 qóVTr;ÂïÏ{ïoBFÍ0©¯;£'§øz¿ÃÝÈ>w£ƒ‰°ä1p‹Ð3°¨ºlµÁXBë,šÞ¿ØÁû7²VqO™Ë‹ñàø²“5åw£ûÜÞ„ŒuÁ{Ò¨ëlòmzõ;Üîs7:/ví¤´7é4¡‡`ñQwƒ±§b°ºi5j³¬ß VdzŽfÉ~ñZöÚ qê~Q÷¹ýCÈÜe÷6Åâ{è!Xüw£ûÜÊŸdW Ì¢»™p7‹ÐC°ø¨»Áì"+Þѹåî4½^ñè7µ$ýQ£F-ñÁXÿz{À¯SÜçnTÇPb¼#£}ÀƉuz¿ÃÝè>w£v¿&Y Æ QNM6½¯BÁâ£î†1?ÈfÝ©GŸÍ‹5Uf#MîÓàꢗéM‰¿A./îs7:¡"[Çœe™Í/BÁâw¸Ýçnt,21ïÑi±É-ñ"ô,>ênà•IXI¶º¼åû+/6‡7*†ó…4å=…ŸÜ¯1-ÆŠ*MÍë>w£CLÃvíP“)ßCÁâw¸ÝçnìÏâo\Ý“ñ™ƒØ"ô ,ڣ‰ªYµ†<ɼ¨­E¿ˆ©†¦YÝ ÃnͼƒÔ U£Ú>wc—Ö±U±ùlÚfzí;Üís76¡äâ±Çm¦[„‚ÅGÝ WŽ7^­Ñý’É‹p/n‡ÏæE ìÖ°¡<…Å}îÆnB*a-b=šˆ ·=‹ßánlŸ»1¹¯~£Ò@Y¼¾g›û¡‡`ñQwÃñòè$=’ÚÚé⯼ÈŽbÓ¢åËî_dŠ63Þ_F÷õmʯSÜçnìÏâïèâ/‘‚gwý‹ÐC°øîÆö¹bfø•9ÖM:Eè!X|ÔÝœ9°ˆýJ’ºÓœÄÁ¤²·NæÅ(+¹zE»™Ââ>wc7!‰W†5Þ>QO-BÁâw¸ÛçnìÏâo+ÑŠÆn†Å÷ÐC°ø¬»¹|–PD,ÅÝàºf5¤Ø#"-9¿y±K½'±û1…Å}îÆ†12w Œï¬ë=‹ßánlŸ»i7!ÃÅq”.U'X\„žÅö¬»!±Ö”«öZrÚpÈ»»tŠ~Ѽլ•QE`öúÚzÂbÛçnZ"SÂ\¢4c™`qzÛw¸›¶ÏÝ´›1°¯*Ê-²ÀäßCÁâ³î†¸“ªãw§õ¦î¿ünz 8Y*àò£HæEÒ Õ¤xnN£ís7m,R­XÅø¬ë_„‚Åïp7mŸ»icy”›s¥™Î6-BÁâ³î†ZÁœ—a¿ùzºþ¯¼Ø¢]l‘±a¼fyTŠtMC-Ü(·Û¦ís7íÏâï #ð‚µæ“~qz¿ÃÝ´}î¦Ý„L×  8Á(irŠï¡‡`ñYwsu¹U0?»áüW^4§Ë :ìðMÞ/¶ø?Ñ*eD‹ûÜM&6®M£¸•¨X&zÔEè!XüwÓö¹›v2POã:¼GÉ2ë4ÞCÁâ³î†¨ÃbƒµUç¤î—© Û£žóÜÎ7ü䊫ƒÒᔬQ÷¹›6¡”jâ™g;¡‡`ñ;ÜMÛçnú¿¡¢`)E¥Ûä¡g`±Ot7W¯&T9OF¬mk˜ÔÀT¼†’¾á‘{% k˜ÖwÓ÷¹›^ÿ _ÀñNã÷í“Nczûw¸›¾ÏÝô!¦aµÖ›tÒ2Ñ£.BÁâ³î†Je³Ëª—”î_×’ªÑ ·ª”ôGeÌ[Q4×\WSXÜçnú„Âv…Èâ†}'“S|=‹ßánú>wÓeždÜ£ƒÀpÏäßCÁâDw#5*Í 3LÉ9 ¬¸ƒZ n¢=ç=uñ¨‘OáÒíÅËÒ ò×)îs7ýÏò¨ÈskN{Ÿ½QßCÁâw¸›¾ÏÝô!¦iÊäÞK™(¡‡`q¦»±"Ú»ÂÄ?éwŸ–¨0×ä^bfóQjÔ„–ânú>wÓÇ T¼7ÐWó2áQ¡‡`ñ;ÜMßçnúŸåQ¤ÑÅë[eöF}=‹Ïº6\j`µ9•µBû¯¼íqw—Z]zZwÊ|ˆ!^s;ßú>wÓ}gX¼+éæ ¶=‹ßánú>wãc 3=€÷2¹ÓX„žEÖݰFE¢BÍí¼X 6☈áÖ>›Y£~Юñ[o¸úÏSô}îÆÇò(†g-lçh¶ómzý;Üïs7~2lñÁJÅnnzŸu70üfïÆ—\^Œ¿'œ +yƒ¼0Û/zsmd¿@Î{Ê÷¹ƒP-ˆ0ªM:Eè!XüwãûÜß„Lƒ‘¨:I|¶ÑvzŸu7‘œZÃUL”™šô‹Æ0˜‚±Mö¬•£Å4jñ÷“Ââ>wã7!ÃP¹Ço³[âEè!XüwãûÜß„ †áÏÍÃl"|z'~7Ñ*V´lii2/Z|q ˆGìäHÏip÷.¤Új£\ºÏÝx»iµxa°ÁS*2ùäßCÁâw¸ßçnü&dH{¯«E3?=Å÷ÐC°ø¬»aŒ’E.hÓåE­Ô±^X“iTF"¦h¯KÎcÃ÷¹bšî$Ô"¥úÌqzz¿ÃÝø6wCå&dZ|M½ÊØ'º›UèX¤ÿþ,ï~1Ò¢ÃË C&ɼˆ5¨˜y‚ 7w×õ‹D…×yZ2<êýyïâMÈt8lÅídUèXŒ_ò+X¼?ï½S¼ <¤}•ÚÄYszŸu7o¨Â°<«Qiæòbo&ñ¯JµG}‹¼89žç¼Ø1¯ÕÍ UÊaq›» °†q·ËuaRݬBÁâg¸›ûóÞ;Å!¦‰v&Þ‘hm&ŠV¡‡`ñYw£WíñkcD(©G ò¡4©í¢B·±ˆ…q^ãMPªcŸSÆõþ¼÷Nq BUiðæ‰PžïW¡‡`ñ3ÜÍýyïâXü­Ñ ÜëdòmzŸu7‘Ø,£]dNî%&Ž*N‹t‰¿H ‹øÉÖš6Õ°KFzÞ{§x‹i(Þú@R3;Å÷ÐC°øîæþ¼÷Nqˆi€/L½ÆëÖ/¾‡‚Åg݈ugX7ËùÝüëŸJÚs l2,›Ñáã«M<—·¹›(4ïd×:ÆhD°yurŠï¡‡`ñ3ÜÍýyob&6FVwSoBF5ùËß-^—“S|=‹Ý `îI£eLzOõÒ¢"Š{ª’Ì‹HÉ‘‹áb6ÅÝÔ}A¨o4ÇÕ'n~«ÐC°øî¦îs7õ&d°ÐŒa”æ4¹ë_…‚ʼnîFLÕ•\•(Õ/âNƒ±i2À…yÍÎ/^¦ŒÅà\®9µîs7õ&dâWŒ…Ñ N¦mV¡‡`ñ;ÜMÝçnê„rî?³³‰ðUè!Xœèn « nc"M%ûEñèªðh¤*JiïÉÉøì ‚ÓøSÜMÝçnêMÈpÃ]“t“*³õ=ô,~‡»©ûÜM&6ñuQå‡þ ·=‹“=S­7vadsKîB…«ˆ^ã ¦­¦÷LiTƒJÜ1A™ÑÝÜŸ÷Þ)Þ„LGû×$~ãyúz¿ÃÝÔ}î†!Óq×d ntÂÀ-BÏÀ"=ën*Là¢*kX ž™ŠÏÓ©—h÷Qj–øÚKì¨ Ì„“ºÚçnh2ñŸ{ÑæñÛNjÔEèX¤ïp7´ÏÝÐÓ¸y‰/ŽIÑI^\„‚ÅgÝMù¹m(Q×ÓÍcÁ7Œ…–ÊÙ}Űo®+̯֛<~â>wCƒ‰º“D f—I§±=‹ßánhŸ»¡a@\âçJÄÛûùßCÁâ³îæê¡!†²^ÅfìÅ£ß,ñÊåErl‰O,šlòŒßÍýyïâÓtHÑãˆà\79Å÷ÐC°øî†ö¹„LcQ!ëV&§øzu7²«q«^k’G w,ìy‘¢rïPGHÏaqŸ»¡AÈÄû„h§oÔ÷ÐC°øî†ö¹º -Ö”Øð¥añ=ô,>ên¨E%w%ØÏ$w¾a­M¨¸T%OÎõƒ?Uƒ£5OyOÝŸ÷Þ)ŽåQJ…{‰Â]ñó)¾‡‚Åïp7´ÏÝðBú †?Ò¬ÓX„žE~ÔÝAŠFQg2DÚɼ(àŒ{uØl'ó¢Á± “×Pˆgf‰ïÏ{ïoBÆÔzTÃqBÓ;EèXäïp7¼ÏÝðXŸÆ÷•gê©Eè!X|ÔÝ ÐX±ì»¯§ëÿÊ‹]T™Ô•9øÉ%`Á‚rXH§xTÞçnø&dzüáz‘@˜L<6V¡‡`ñ;Ü ïs7<\Rì Ú¬F]„‚ÅGÝ ‰–BðÌ‚;bÒ{ ªWõ$rªFÅO&·WÃE¬3ò¯SÜçnXoŠ›µ,§ó6롇`ñ;Ü ïs7|2ñ•‰oLt<óG]…‚ÅGÝ /=*Lø×f~çE˜ÕHü‘Ëi²û‰[w5WˆðÖ.É¿NqŸ»áÛĦ\žR-Þñú˜œâ{è!XüwÃûÜ ÿ1±‰/«4‰ÆÈ&ÚðEè!X|ÔÝÄÛ +?ã7Æ’ðd¿(Zkt}äV{ç¤oøµŒ»< i(Å£ò>wÃ7!ã FàQL·@ØäßCÁâw¸Þçn¤Œ‹ -ñ’ôÒJäÅEèX”GÝ ACË—õųý¢X+hŽI±Ô4©»!l$öÎÝk4­Ëi­ÿw#7!ÃHsÖ©2Í\‹¡‡`ñ;Üìs7"7­Æn—£öÙDø"ô,>ênªžDÜ!‡^«BÿÊ‹XÓ;|¶kÔ«¹¼µm¼´aV‹zJ'ûÜÜbÜýÂÞÍ{“Éýâ"ô,~‡»‘}îF†‰ oV Qœbñ=ô,>ên. Š›%ó¤U¬Vņ;‡î&9§Q›6è*—ä.ÔûóÞ;Å[L£ÐB¡­ã™U7`ñ;Üìs7ÒÇEE‹Fª6Ðw“ûÅEè!X|ÔÝTÅRsÌ¢uKúÝD>…lÆŠZÃÞÐ\^TøY4gÜS<ªìs72Ll´õøâ÷äÉn›Uè!Xüw#ûÜþÓ¨Q¼ÀÉ[›`qzõQwYÉ Æ„Ä+å¼§"/ ao¨ÖRaµ‘Ì‹t)\¢FÆZT^Ô}îF!S‡\^TÓÒ›F[<ªÎ÷¹mƒ×c­×ˆØd~qz¿ÃÝè>w£c*yÄÛ[gÕÍ{è!X|ö»›\—i&™–ï'/ÂܧW茺d÷LYÅ ÚUÔ+),îs7:é‘ÁÑ–ÉFÛUè!Xüw£ûÜÝ„LôSX/(Ž îϧ¸=‹ö¨»Á{o]WˆdÖ¶ýèQ£FEÁTMênªX$eLõGEßS5ªís7v2Ñà F5 ³4“S|=‹öîÆö¹» ™Ö¤–VŠ”F…ÿ"ô,>ÏL ˜ÐB¢ý^¡¸i7ü“Š-²#I¯¹¹þ¨Q£˜gÞ¬ˆŠôÕOþuŠûÜñ™VõËLy£.BÁâw¸Ûçnì&dˬ!‹ªóS|=‹ÜMÅ(p´ÑÅì*¬sy1zM,€ÕV°W;« /d†5'Z?þ:Å}îÆnBFâES ÿK—‰Âz¿ÃÝØ>wccªb­bQæ>ëú¡‡`qâUŒq`W…SF®FÅý"tÔ9±rÒÛæPšÆ‡ÕM!Ì`qŸ»±±<Š[¼9¬T–ÙäÛ"ô,~‡»±}îÆú°+M êDÒÙ)¾‡‚ÅGîfY„@ÿJæE#xÂ`8òjr–8PLX>ÒP#÷åOþuŠûÜ âæÜ݃Ӭ_|=‹ßánlŸ»i7!Ó«E_G]óI¿¸=‹í‘»A¿[c)‰l^ŒºC [ KzllQMYÜ;•%ñóŸ§Øö¹›6 ˆ[†]P|Nn¦¡g`±}‡»iûÜM£abM‹j«MúÅEè!X|œ™jñæ ܶG­Yzö~± Iaw‡ê>Ù/ö€q«½Áë˜×*ƒ_§¸ÏÝ´!¦Ñ wtÃ…ÅäNcz¿ÃÝ´}î¦Åß ŠÞÆ-hrŠï¡‡`ñqfÊ lf‹—”¡‰2ógÿ"Å3NT´m\Kü΋Q?Ð%»i—ÉF ‹ûÜM„L‰ÌÏÆK™½QßCÁâw¸›¶ÏÝ´›)²˜[šÜ/.BÁâóÌTôjǰà&©GíÑlÆ•#‰¥ô¨øÉ¢Z¢®§R´¤ö·}î¦A¨Xü‹ËD±±=‹ßánÚ>wÓn1E’«ÑÔÔVÚ„»Y„‚Å癩øßaOjâ¸ïËÎ/jÅc ¶7’Õ†sUc(ï¤êú-ðë÷¹›v2jjQ®pœÍlCÑ"ô,~‡»iûÜM/ OL´ÅW¶· ·=‹ýyfJ¬t\bD?»OC¢oUUfëI \¼´zÇÇ€r¼Â2XìûÜMb“†åâ¸Ôœp7‹Ð3°Ø¿ÃÝô}î¦A(&xÜ'÷‹‹ÐC°ø<3eX.§&œóð‡ßÔ5ª«·ônt¨¸ØÄÆ8ÖT^ìûÜM¿ c­Ò1ú¨ur׿=‹ßánú>wÓ!S ¶‡ÅäßCÁâ³î¦×ïðÚ{ÿALÍõÐ(Ò£zIzOÕ®¸I‰ŽQX×[Xâ>wÓÇò(LiÆÑ`KÝ„»Y„‚Åïp7}Ÿ»éÃÄ ‘8Ê–Òfþ‹ÐC°ø¨»‰ŒhpÄ„®·Zü•±Õ8,Ô krGxuo$íj‹¥<û>wÓ‡qSØôîM'lø"ô,~‡»éûÜM&6Ñ9DeK™Ýõ/BÁâ³Wq­-Ÿ‘›çv¾]y‘¢WäVTI=jUa‹ÏÊ­dûÅ}î¦ß„ ÷¨8±ÖJy¦ð_„‚Åïp7}Ÿ»ñ!¦¡x}»Á|V£.BÏÀ¢?ên(À ü ²¾á`ŽŽ‘¬¶wƒŸì¥:†[kœÂ¢ïs7^9ÊVÄz£6só[„žEÿwãûÜß„Œf‹·Ê&§øzŸ½Š)>6‚Œ6Ÿ¹°“Eƒæìn›è¬™‹qé&¹ûEßçnœïšË =úâøcNxÔEè!XüwãûÜA(¸ôùµ­¶Ìި`ñQwCR†¼âËgª©; ð¨ðƒm=2'µáøÉZ=êÁêÇuFþuŠûÜß„ŒW!ülÏÔ"ô,~‡»ñ}îÆoBF±A[Ìa¨;¹_\„‚Åçá` £Ç5BvJî%ì{Ãj-íTÒó‹Š‹Œz^²ô÷¹¿Å4Quv‹ÜíNÓS|=‹ßán|Ÿ»ñ!¦iÂÒz+iorŠï¡‡`ñyG¸ –®5‰ŠÑ$íßÛÖ£$×äý"Ž;ã<ÐØS<ªïs7>Llº÷Þ:ZÛ6ëúßCÁâw¸ßæn¸”?ÂQt6,›Üi¬BÀ"ÿ÷gyï—èÖâËçà´?ªµ.íŒöžôd$ƒ?áqoë­:ÿqŠ÷ç½wŠCLSaýo¬ðžœœâ{èXŒ_ò+X¼?ï½S¼ ™âpËtb£‰÷Ô*ô,>ûÝD-Öâ7·Ú*·l¿}¢DE‡yM÷ìη.XÇÝñ¥çõ&_§¸ÍÝp¹Å4ص4vLN”Œ«ÐC°øîæþ¼÷Nqˆiï‡ÁE/¸woe­Dû+/6lm‹¢.þöɹ~ruc¯0ÏhàîÏ{ï‡q |];µ¢úœœâ{è!Xü wsÞ{§ø‹¿™«4îÿUè!X|ö*.LÎlÐ"«çò"&ž¢Ó4îÞJnf ?9ºjkUãl´¬Žâ6wÃe2ñ¦Áu·Ù-ñ*ô,~†»¹?ï­S¬cªEÎè|­F›Ô¨‹Ð3°Xu7ñ½Öèn»•ÀU[VŠ¿O“Ò¡®#Ozø3 ˆ)â¨Y2<êýyïâ0±Ár9¼4¬ò‹‹Ð3°X¿ÃÝÔ}î¦þ„ªQ¼¥¨A' Ü"ô,>ên°½šv³Îª©á'é€t8RdóbdÄ?2þþc °Å}î¦1a¢Mª6,x>Å÷ÐC°øî¦îs7õ&dZu©Ía±d“uzu7\[›DÀÁã’Ì‹XŠŒ(Ö¤fÌr®¼x͆D:­Ñ_{f~ñþ¼÷Nq BulWÀJsžènV¡‡`ñ;ÜMÝçnêMÈG—IxƒÓd[Ø*ô,>ên"\©Ñ©ö¤î&šM­âð„%Ìúåò"ah*:l\iŠ»©ûÜM„LqL‡uxrŠï¡‡`ñ;ÜMÝçnêm@ìM"c´B:½_\„‚ÅGÝ „˜ª]²ýb¯øÞSJwCûÜ Õ?…'”Rûîfzé;Ü ís74™†½Œ+8{žÓX…‚ÅGÝ c%)—0 Ìɹþh{×Þ´µè±²ý¢‘0Ç‹êðœŽö¹&6NÚ"aÝÍ"ô,~‡»¡}î†nBF¬™ÂÔËLɸ=‹º›@Dô|êÖvlɼȆàH«B½%õ¨l¸ý‘(nëSXÜçnh B]V9|Ò/.BÁâw¸ÚçnÈî£á/ÈB›Õ¨ï¡‡`ñyÏ(üŽYv×ôý"q (¾¶"Éší;|à îD`-“Ââ>wC7!s©Šª {˜ì™Z…‚Åïp7´ÏÝÐXüµ[”bØ¿b³êæ=ô,>ënòhd€ÆJI•âkf`oš§ûÅ.x°ÆoV5u¿HûÜ 1 u½Øâ¦“ùÅUè!XüwCûÜ A(‰ÿ«]Uç ·=‹ü¬»íY7z±òz¢÷÷)Vo-6bDƒÕKÒ.+ÄâÒkIæEÞçnx2Øý1¨ø‰“Nczù;Ü ïs7|2Øfïnt²¹ozŸu7]P›Â.*ÎäœFT^J­›¥ã\yÑ‹‹`«pt­),îs7<–G«Ý )ÆÃ&§øz¿ÃÝð>wÉÿRe§•Éýâ"ô,>ënº¡]³ÀEÔfIµ6Âjœ(åjíéûE§¨é[si)¯âûóÞ;Å›i ˆâ'E®›)6¡‡`ñ;Ü ïs7<¡¢©‰×·ÀRwvŠï¡‡`ñYwÓ±ðÂêÒS5jäEl|ÃZ&"sËêQa%Ðá_ù\¿ÈûÜ 1ÁÓ#š@üy'§øz¿ÃÝð>wÃÃĦ;E_Ïʬºy=‹Ïº›¦¿€É,lI=*Þm¹Ñ=*Ýõ Å¿ûE"%ÇHKÍõó>wÃ> OÂR¬ ™Ïä®z¿ÃÝð>w#7!SS*ÑÒËäNczåYwÓŒãÏ=4õµBû¯¼Xºƒòé ÷ŒÉ=SܹDµYãoÐKNw#ûÜÔ!O$líàZÜ'ÕÍ"ô ,Êw¸Ùçnd2] mì}òF]„‚ÅgÝMëE¶a3yNWþ_M©%ê9çvén&Çóœµ\0Oí_¼?ï½SüCÈ4ÆÎhþf§øz¿ÃÝÈ>w#2Œ34ʸθ™~ÞP´ =‹ÝM/Í1Ýߢ=JÎõ ×i‘±'žÎ`Y‹S|é…ú†úî×)îs72¡ˆñ&.l¦ _„‚Åïp7²ÏÝÈMÈÔÚ£Šº¨ÇërŠï¡‡`ñYwXìÝpc¯¥¤°X°#¼16q˜F} 8I"/Âj vÑiÆW?…Å}îFÆò(øÎÄâgNNñ=ô,~‡»‘}îF†‰ ü;MÕ.¶ïùßCÁâDw`¬…~Œg’ÞSLôh4Éu!’É‹d- OÇ”oøýyïâÓà= .˜×œœâ{è!Xüw#ûÜÞ„ŒŠ—?nŸ±á‹Ð3°¨Ïº›h‹$þŸTkdÆäÌ”]»ÞðÅ…ì¦$ûEôe&;^¹§îúuŸ»ÑúGd¿,ìy¬Nô¨‹Ð3°¨ßántŸ»ÑAÈ(\ltu†Å÷ÐC°ø¬»ÁJ ‡ßy´}ëmO¿O1ʹèõHTÊa*SôÖÐE»™ºë×}îF!£\¼GoLqB“S|=‹ßántŸ»Ñ±<ªcx5¾l𢘜â{è!X|ÖÝ(±EÈQj 'g¦¢$×úS žânð“½sü^9œºë×}îF!+)l*À€ØäßCÁâw¸Ýçnô&d¢,>€Q}Îި`ñYwøAZ¢âLÝ/–0oë”cT™×u}&/b¡1ìq³™»_Ô}îFo1MëÍ,Ú‡Hz2éú¡‡`ñ;Üîs7:¡â{&uKo2Qø/BÁâ³î3ìQ’º¤õ´Ä_yÑMâ‹Û©ô›É¼ÿ€œÎãñ™¥°¸ÏÝè0±i±Ò$ŠÏÙ,ñ"ô,~‡»Ñ}îÆ†±Õ¢ 7éj“êfzíYwI­Hm'Óõ†™¿òâu§6ør6/Æç…E•Ñ+VꩼhûÜ 1M—Bpuwž)¡g`ѾÃÝØ>wc7!cU¸EC/ñ¾=‹Ï{¦â›g—iTÒwýý^U€¹ØÑq&/(Ò##ÇÏ¿O ‹ûÜñ°\P3X”GÖ›Ü/.BÁâw¸Ûçnlˆi:ÃMWªÅÿMNñ=ô,NöL¡$#®Ðiçö/–º;|}£ J5É£’_Ûã­%ñ.HÝiØ>wc:†/¼Tß½ôY^|=‹ßánlŸ»±›1³ŽÃqbŸhá‡`ñyÏT«Q+FŠ‘ŸË‹½c:ŠL¬HÞ/Róªíî”–›™²}îÆ†‰ 7wi(wÓê GQtâË—çS|=‹í;ÜMÛçnÝ­¼‚¥Âºp¶qzu7}žD&·‚ÃÉûE­­S­¸#äÔÌ~²c£.ð6HaqŸ»iCLSkœ ÇÛÒÊ„ _„‚Åïp7mŸ»iCLýcY§GÙ2™B]„‚ÅGÝ æ@…2ö¯7¯ý΋°7Ž/n4~X“¼_ ·µ±¸[[wª¿NqŸ»i:š@EX£ƒ˜ÝL-BÁâw¸›¶ÏÝ´abƒ© í uȬF}=‹º›«$ÃFà©¶äœFõVá&ŠÕo^,33õcÕü5@™Ââ>wÓnBFâ…ÃÐùͼŠ¡‡`ñ;ÜMÛçnÚMÈHTo­ö2ÓX„‚ÅGÝMUL$—(°©&ïú1±éñ•uõè7“wÓoB¦DGU©}º uzû£î¦2Œ]9ÑJvfŠ0”Í&Ê’œ_ŒßÈRO¤!§TÚ÷¹›~2°&g¬@¾¼XŸOñ=ô ,öïp7}Ÿ»éLlÓh!pVfþ‹ÐC°ø¨»ñ(R;ÝÄJŒk·MÁ^µãµ-—Kíܪ¶xäòâ>wÓÇ «&„©Ï\n¡‡`ñ;ÜMßçnúMÈp¼¡¶”*4é4¡‡`ñQwÓDÌn’Mý’”ncñ_ÿ(®{‡ä.×/ö¨ã½}ª/—qü:Å}î¦1M´ð,ܨ˜LºþEè!XüwÓ÷¹›þ‡ÁƉ·?¼™žOñ=ô,>ênUµ+³Hhry±·†…8E.ÝX²_´Žú†ŽQÚ¯ãü:Å}î¦ÿY…1KÊEflø"ô,~‡»éûÜÿ!dÐU.Úfýâ"ô ,ú£îF¢>­ÄgE¾à”È‹•„È,°µ@ÈÈ‹QÎ36Œ—¨!ª¦°èûÜA¨Š»qµèS'§øzý;Üïs7~2/ îÑð˜œâ{è!Xœì™2‹ ³—x•äò"6¡:üD±¶&Æ)J'fw¼ OaqŸ»ñ±øÛcÓæñÇœÜ/.BÁâw¸ßçn|2ŽÉ÷îÑWÙ¤ë_„‚Åg¿›"&Þ:vwËæE숢†Œ­¯SÛï¼(…¨Ié˜Àî} ä_§¸ÏÝø!Ók©nP¿7’Ù)¾‡‚Åïp7¾ÏÝø dm·>qrŠï¡‡`ñQwCÑQ8f¹[b…âîÆ1ôĸ !Jañ2W­Õ%’\Ñ"Ë÷×)îs7þÇ€ƒ–mqm“~qz¿ÃÝø>wã7!ƒÍ½ÑE HmÂÝ,BÁâ³î†¡õІ Ž5”Xõ³#Ür7›ešì¿=§+/6‰bœ;ñTR<ê¿þXìH•V`@·–ÿ:ÅmîFÊ-¦‘ø YaÓÇï©Uè!Xü wsÞ{§8Ll¢a¬å›(W¡‡`qÂÝPƒ²›½PTÉ~±_nŒQ ˆ'w„W(w »mê%ßÍÔ¨ÛÜ”?bãZÝÈûD¾ =‹ŸánîÏ{ï!CT(µ•g Ü*ô,>r7XFï¥ëE•¼_ K³Ò”µcÖ/•+ìçz³H­íÇQ`‹ÛÜ”›éí2à¢^ŸÄV¡‡`ñ3ÜÍýyobb«$EtD:É‹‹Ð3°X¹6wQ†±™ÕÔ€\¤Å{ÇÉ‹PâròÇ{бœɸ`Ì`±îs7õÓ4S L{ø?ß/®BÏÀbýwS÷¹›J#Ù5¹ö…68ê>Ÿâ{è!X|œ™ŠŠÖP£ÊçE¸O5šJºLmq7µûµ\) û÷¹›z2=^øpj>»ÓX…‚Åïp7uŸ»©?„ŒCtéñö§É´Í*ô,>ÎLI ]ŠG™Ê5§µk¼y¸úÆd^dëUM4þY~v¾ícqŸ»©7!}1AöMÄ¿›Uè!XüwS÷¹›:G÷É.r@›žâ{è!X|œ™RŽB3áª5qEøs¿¨­ü¬dêlÉ~1zw•+¦g,—÷¹›z2®Ø…{P£I¿¸=‹ßánê>wSÇò(Áw#î3,¾‡‚Åç™)S&sªÑíKÕ¨ÐÝA¾Éþ3%–Ó†‹W\02æ¶RXÜçnêÓP4€ñ²dbrŠï¡‡`ñ;ÜMÝçnè&d:®Áœë”[„žEzœ™²¨»ÜÖGmªQæ‹`W°Í4{×/Ý ùŒ¦¬ÔƒŽm,Ò>wC7!ßZœ‹±Nf‰W¡g`‘¾ÃÝÐ>wCCLFƱF[f7S‹ÐC°ø¨»1E™Y:²€sÊcB‚A`*ÑòqKq7‘‘<—Q^uÉàþ:Å}î†Æò¨xe°` ¹Õ ·=‹ßánhŸ»¡?&6Œ° vNNñ=ô,>ênZÁtIkþ–œë‡V'jÔW É4›×,q¿FŸVOÝ/Ò>wC7!Å7Þ‘jŸhࡇ`ñ;Ü ís74Ä4­[N˹OxÔEè!X|ÔÝ4¦î0¹Àî·’œ_t¦j¤ùM´$wÛXiUHª\êò'ÿ:Å}î†Æâo”àjŰ}rŠï¡‡`ñ;Ü ís74Ä45¾0`ýµÌ4p‹ÐC°ø¨»iQXGåN˜÷ê9 \”™¨tÌL‘ò5§‘ðž2ekXÁµ±¶Ôœís74Ll®Íß­Vá™bcz¿ÃÝÐ>wÃc CÞðv³:Ó†/BÏÀ"?ênºa¡)|Ap·‘ºÓ¸¼Š•Pi²Š·”2r'‚ש›•õÀÕž"ïs7|2(=cÓ@Ÿl […žEþwÃûÜ ß„ŒR³èˆŠ_Ìûó)¾‡‚ÅGݳ@ñÕ©z­šê#µ1V0_ 9Ü[jŸÆ¿þé ‰»1F5J*/ò>wÃ7!ƒf˜zï¬Xfþ|Šï¡‡`ñ;Ü ïs7|2ЇE‡û6;Å÷ÐC°ø¨»©…áuµ"ˤ¿O1`ä•£]„ƒTfa‘ ¢Å„XÆîþ¼÷Nq BÅ;²µxó`úbrŠï¡‡`ñ;Ü ïs7|2$.¸þ…¹õä~qzu7µ8̧:•hùJrª˜bÙ[#ޝÉ~Ñ­FÉX¢Õ\;Ðý:Å}î†!Sá+‚uÂÝ,BÁâw¸Þçnx,þ6‚ÇRsqÜ/BÁâ£î¦VHÊÌ´+¨Ôä.T†o¸X«puLîBõŽùEð#q*9 ïs7<¹6Û‘˜µÉäÛ"ô,~‡»á}îFnB†£›2˜cÎîù¡g`Qu7‘—`Í f1Oí|Ãa4ŒÐ‡7#íɼX ®4*.ó°•#±Oãþ¼÷Nñ&dJÜú2‹Ï:EèX”ïp7²ÏÝ Á·’Ã)­¨Oòâ"ô,>ênj€!¾s‘Ö¢Çõäž)c*QhëÊ”ÃâÕ©*vâ¬rdùøuŠûÜðÝ>ÀƒØP†O½§¡‡`ñ;Üìs7"#ÙqôòVgϧøzŸýn` ê{ÖÛÿâQ•šT‚-…bJ,—£U-ìBNpKÖè×)îs72–GÅë¢ôve² uz¿ÃÝÈ>w#7!#uº¥˜Î‹ÐC°ø¼#œZ—~9ºFŠLî%¶ÂÑk¶h6ñ7‘d^¬Ìã×RrÙ©þ:Å}îF†‰ ä³d¢*^„‚Åïp7²ÏÝÈŸåQ¦ÞQ‰ašàùßCÁâ³W1EF3"`ªP2/jéñ'ÕŽÜVZjÏÔ•#‘zü‡jËŸüë÷¹ñ?ª˜ ‰wÖi¼‡‚Åïp7²ÏÝèÓ¶h¨Œ­ÍjÔEèXÔGÝMT˜‘—´3 ×–äQ=f/t]—t¿H,èÎ5ƒEÝçnt˜ØP?hÔ+Ø’19Å÷Ð3°¨ßántŸ»Ñ1_·æØA3ßðEè!X|ÔÝ 0m¸%/­,7uÿ53Åm&\«šPî®<*iô‰DLR׬ѯSÜçnt B5,$ïXV “~qz¿ÃÝè>w£7!£^Ä ¶!I™0p‹ÐC°ø¬»Á…{¤‚ó)NénN؋Ӭz$¶¨’÷‹Ø¥~ ±9^_©¹~Ýçnt2µzwÅšΪ›÷ÐC°øîF÷¹µ0‰ÊÓKÑ2Sl,BÁâDwÉ—c`/JÆ$w#Ñ-Fq|“y±;w,S/V¢/KÝõë>w£cy÷î°F·©zjz¿ÃÝè>w£ý.Y¬lˆ@ÝÏNñ=ô,>ënÊeGmhÕ–Ì‹ØVÐT±"JºäŽð®o‰Z 弊uŸ»ÑabÓœó¥¸MNñ=ô,~‡»Ñ}îÆnB®`—MÝgþ¨‹Ð3°hº\'¬¿…Kͬm»æú!†ÇµCÑ”ô»i¨Œ «T­xn–Øö¹»—GÇ…!¦õ'w‹Ð3°hßánlŸ»±!¦±nÑË«ŸÕ¨‹ÐC°ø¨»ñŠ ß|Yd¹äÌö&r<ˆõÂ-çU|Í/FYÌØMNKª~â>wccÊ›0GïPúÌÍoz¿ÃÝØ>wc7!'}ên¢®®Ñå‚|ÑZ²>pRŠº6'«nÙ¼(rq$TLˆSžŒ¶ÏݘßM`ü£ICõ|Šï¡‡`ñ;Üís7혦RԜՊÍòâ"ô ,¶GÝÍåÊÅaÕ-¹gªªF•Õ€Ã&ñðO^Œ"—ýÖ[Ò«¸ís7mG]¥{-2aág`±}‡»iûÜMû!d< Î^´«ÃfrŠï¡‡`ñQwÓ¹:qoXl=ÑûW^„cF‰z5™µi؆÷«½Î`qŸ»icñ7d¯ðç‰ÿuR£.BÁâw¸›¶ÏÝ´›©®‘ð„+½'§øzu7dAIËJ-Û/“G«x‘7%¹—ØZÁÞEWol~üuŠûÜM„L4§ ‘"äè“S|=‹ßánÚ>wÓ†±ÆWÍur3µ=‹º›¨Q-^è£XM¤¶Ÿ¼ˆ Ì #GšÌ‹êÝ($lcyã¯SÜçnÚMÈ`q”téè'<ê"ô,~‡»iûÜMƒP]Äp§]‰fyñ=ô,>ênºÃS]_´mé~QªrÔ.ÌURÜMù§Ubƒù\ƒx./îs7m˜Ø8V G¿é¬Óx=‹ßánÚ>wÓËHvνc¯âó).BÏÀbÖÝ ·&"DÈæEXåÀ[ŒhMÝiüëŸ *6L©a!G*/ö}î¦B&~܈Z”.ÅÆ"ô ,öïp7}Ÿ»é·˜FØJTž­G55é4¡‡`ñYwhÂc ã*¬Sy‹˜à¯Í°®ITp$ñY)ó¥7KaqŸ»é7!¥§Á„8þŸÜL-BÁâw¸›¾ÏÝô±<ŠK³xwÃypÒ/.BÁâ£îÆ#«f‚%Ú\Nên0»X {tX)ÜlV5sê°è) \ßçnú d •8è"ŸùÝ,BÁâw¸›¾ÏÝôAÈt¸ºÅ×&Žf†Å÷ÐC°øìwƒ¥æ­8à¥3â(…¡%]‰ÐÏ^âÔœÌ*+™QIy÷}î¦ß„ŒÖ˜G0ˋ`ñ;ÜMßçnúMÈlŽbÂ?fªâEè!X|ö»©µ‘ƒ@1–’œ_ŒtHpŒ’\~<6û4°B5^[ s`ë¹uŸ»éCL#ñÒPøe:OTÅ‹ÐC°øî¦ïs7^î¡Ä^ ‚olE›T7‹Ð3°èº›J¬¥‹Ã0«iÊ{êºÓ°hûpiÏ?’Ò”ß iT.°“½¶Ím{lø>wãƒ1¾–€u§Yu³=‹þîÆ÷¹¿ nQDGG?uÖ\„‚Åg¿Žœ¦˜"tҬdžTruÜà)’Ú…zmò eªwÆ:Ô÷¹¿ ™Ö#ã%^“;Eè!XüwãûÜß„LtQ|Æ›²•™Ü"ô,>ûݰájzTŒ÷'ýQéšÓ(°j¢q!i‘Y©¬]’â>wãcñwUƒ.é ‹ï¡‡`ñ;Üïs7> ˆ#aW¼%}r3µ=‹Ï~7ÂÍ9E7kI “ª6loÌîÓˆlÚ¡ ÖZIy2ú>wã7!£˜¼è ë³­(‹ÐC°øîÆ÷¹¿ ™æ•Xãjmv§±=‹Ï~75u™jkDüÅÝõ r‰><°œÌ‹‘#›Öî®&)OFßçnüÓDÏlÞ˜§û¡‡`ñ;Üos7Z†‰^†îEqÇüxŠ«Ð#°¨ÿýYþäÅV±!8/’%ƒò;/:æÃ¢Í4ÆXpjçÛåXÞ“̼‘‘ÿãïÏ{ï‡1LÁ,ÑlÏÔ*ôÿ ,^Ïýßâ?ÿ_þÇÿ+þ×ÿù¿þ/ÿÛŸCýÿþ?ÿÿóüïÿŸŸ±Æ»°:ÆÀáûkEîoÀÿýþ/ÿûÿÄß~<õ¿ýÿñÿþ¿ŒOþýk‚¿íÿ©Áþä)ýû+‰ïÏæW2þA·¦Äâ?¶Ò«Òå7XÿþJ.COx±àŒŸ^,\°ðœÁ…'sßy]––b„Ñfø/[v9¦sœà:&0Aÿ¿î¾XÆç½wŠÛ¡5Œb`Ô½^?žNñ=ô„$½þÏŒû_§¸KDÅ?äî…,ÐU®ûö(®]†‚ÅG" ½otìÚ;a€-ƒE<Œ+ÅFðAWN6¿ÌÒkAp=S,uŠ»DTücl1¿Z¡ø‰Ýž‡N–¡‡`ñ+DÔø¼÷Nñf—:ô²^+Ú/h–¡‡`ñ‘ˆriQl×nÍÔd^t‡ŸÅ_±k9¹d™ºÀ<ÎZôÏ?yqÿw‰¨øÇØbÞ ('‚´Ç¶iz¿BDÏ{ïÇTWÕ¨¢(¾¯“%ËËÐC°øLD1¤µ‘£õµ…Î_Â6\“ÖJ8 /F.VU7r³~qèû§¸KDÅ?nv©³W3Håy0zz¿BDÏ{ëëØbÞ ‹Š1Ì1žOqzë3E™\®%éaL‚³cÇ»ËZûW^d¯½6ÒØ8uŠu—ˆŠÐ›]Š´íä8¶}Y†žÅúnžè×)îs7uLuSªÜ;¾r“S|=‹`Ðï”rVUZ‚~¹„ ",í# PåúE 0bG¼ø§ŒØ?Å}î¦ÞÊ ü–ñÇ„‘k}¼ò^†‚Åïp7uŸ»©ÃMY¹EÙ ™”É)¾‡‚ÅGî†F†×¦29ÉÝÐÕY™Ö®°œNö‹Å‘+¶þÕ’ªQë>wSužÐfD+(mšßCÁâw¸›ºÏÝÔ¡ jñ]k׸ìäßCÁⳈˆ+– P‰ßÙ9µäz8^=†Utf™÷º,ÇÄâ%€û¾k Çþ)îs7u8ò»îd£ |6A_†‚Åïp7uŸ»©yJ§¦X„!³êæ=ô,>r7ß7† ŸS¼CR&×öѢި-ij÷óq*%lNÝiÔ}MX§/›kÎrrŠï¡‡`ñ;ÜMÝçnh2¯üŽ©ŠR¥`ËÐ3°HÜ :Åhפ7PÀ)ór7`@Å#Ó\~¯É;xظUÀõ¤ zG9ÚU¿ŸS5*ís74¦ºâhXqO6©n¡‡`ñ;Ü ís74™Ug‡S”Ì`ñѼkYKÇkéêIãåx8Þ?Q©’TŒŸæò¢FFUkÜ{ü ryqŸ»¡AÈ`󗆄I׿=‹ßánhŸ»¡AÈÄ;Ò<$¦ÕÍ{è!X|4ï1 ‚® tîåòb<¦öÀ³UK-vŸ‹¶ÈÅËgï’:Å}˜& ñÒ,ø´_\„‚Åïp7´ÏÝÐMÈp¤¹xÿÇ7FlöF}=‹æ=¸•ðÞ®ëöÖSX¼\Ø»¹ÿx~dò"wLœ–è/oÜýSÜçnh¸)wì»,ÉîÙ¤`z¿ÃÝÐ>wÃ7!s}aå­Ð¤_\„žE~ànÊ?#ËD·‰1*ìTz=,fpi§l^õÊÎñ$ÖàeN‘÷¹¾ ·cÀ>Þþl5± =‹üî†÷¹¾ ÒVÕ{ï]ÑäßCÁâãÌ”XÚE‹T©KÈØ.mx|ž)ŽÖJH²÷‹Y.G¥wº¶6îŸâ>wÃCLSE\ºñ„»Y„‚Åïp7¼ÏÝð dpդįýÙšpzu7Q^–¨)ZF°7¹¼Y¡R[©; ˜÷DŽÊ¶báVNÊûÜ BF1*¯‰æäßCÁâw¸Þçnø&dXšD÷ßÕΓ®zŸu7—8{kP|¥Ì^¯‡+Dl"ñºv l>|åÅJŠöFÅ›¥f¦xŸ»áAÈ”FJñæÀÜôäßCÁâw¸ÞçnxˆiÜͽ@X>«nÞCÁâóÌl­°˜5{‡!#µÀq ‹xØ´Pu@‹$Å£ò>wÃ7!©®Âê½£œœâ{è!XüwÃûÜ 1FèRmÖ/.BÏÀ¢<ÏLUmFпÀ,#¹wå"pþñÌ^Iz¯¾1>²Ì)Ê>w#cЏ7öîpmŸœâ{èX”ïp7²ÏÝÈMÈhãø–r‹:J'oÔEè!X|ÔÝÔê+.^¥7Kiý<¬Rœ“ao›Ê‹ÞJ•Ë<Öˇâ>w#Ü”ñgì‚ý0“~qz¿ÃÝÈ>w#2. Q¼aO¼Å'§øzu7•0GÜáMÂ)ƒÉŸ‡£˜£Â —‘¿ó",)=<_1‘Áâ>w#ƒqlèÒjâ4;Å÷ÐC°øîFö¹beÆp”Z&7S‹ÐC°ø¼4‹z¼<Äk-\=e¼üó°c»T%laÈåÅŽq©¨ +‚4a09>ï½S„L5vžLøyÝÒ2ô,~‡»‘}îFnB†ŠkÔRSÍ ·=‹ÏK³8ršÜnÔk"µÑýp¼}X0µ)‰¤z-“ŒªF>fÅÕ\^Üçndˆi¬ö¦ E@›(6¡‡`ñ;Üìs7:™h,ŠÏ(äf ÿEèXÔGÝMeåÞE¯¨T²ý"G·Èª¥R©š¸¹òbÅne—ˆ§ò¢îs7:¡Ò÷‰\žMЗ¡g`Q¿ÃÝè>w£CLC~qkÑÎæ¡‡`q²4+ú#Á•;³¬ñw^D0¦(2Í&òbÃUJ‰æ ë]«¤°¸ÏÝèMÈh¼j“–>Yìº =‹ßántŸ»Q"ÓÎl¢¯ñ ·=‹“¥Y^»wä6©e‰ˆ¿ó¢SULMõ|¿­b-Ö:œÿÕR<ªîs7:ÁÞK††]'b‹ÐC°øîF÷¹½ ™hâ sATÏòâ{è!Xœ,Í¢¨P£ª–ø–ä2I<ìQ œL2›E®¼¹@³{ƒ¥l ‹ûÜŽ-æ kãTÀPMxÔEè!Xüw£ûÜŽA¨;)˜ƒõ·=‹“¥Y$Ð]ºÀæ4u×ÿó°a[ ]©$—£~ˆ¤HQãJ'I,YŸ÷Þ)Þ„ŒVÈ–¦UeÂÀ-BÁâw¸Ýçn¬Œ&&IfhŽ&ÚðEèX´gÝTŠî–°IŽ-U£þ<ÜAý´B}½³üw^4‰"/€Rµ®Y£ÿwccªàæÄ“vËÐC°øîÆö¹ûc@\âÛfÄf ÿEè!X|ÖÝH!쳈µÈºRü;/‚AGäFImKG^Œ÷Eψ•NækÑίSÜçnll1§Ôz2Ql,BÁâw¸Ûçnl B] ºT"3,¾‡‚ÅgÝ »rƒS±>2Í£FöÀÝ;[©É9 ,Ám‘Y±åJjŠ»±}îÆ†˜¦ÇŸ“QËL¾=‹ßánlŸ»±›)ØB|Už­OØðEè!X|ÖÝ µuSx•¦ûŪ®¯__Kü•£4.°ïwG·šÂâ>wccyTü¢0ÄjÌÉýâ"ô,~‡»±}î¦Ý„ŒH“¢ïþ2{£.BÏÀb›èn\¢¢æý^•ìüb<ìéV†É¼HŠ…Ä5°¬ºžùÏSlûÜM« ÏìW˜tý‹Ð3°Ø¾ÃÝ´}î¦ BD_¼Š£‡¨“¼¸=‹ÝMÇí÷É<#)¥ûညRr®{Åq?I 9lJÚö¹›6¡K¹)ÙÌnz¿ÃÝ´}î¦ B&^ÃÊ5Æ>Ñ£.BÁâDwcÛ”®¦ó¢hJdj) \ù·Šj¦å¸LaqŸ»i:D¦ñÇ£hŒ{u‹ÐC°øî¦ís7í&dÌ0¯ï-RÝL±±=‹³=Sp¬}xõ zï™*‘Õ¨sT«œäQE«H%˜–×HE),îs7m,¶Ì`ë1s¹]„‚Åïp7mŸ»ic Ûj·d+“®z';Â#Ëxqx÷̨݆«VOò¨Â0° Vâø RXÜçnÚMÈh@ ‡¥Ç›œâ{è!XüwÓö¹›>Ä4ÍàwІh6K¼=‹ýYwC ,h ¢Ãµ&;×ß Ó¨ëÖ×åÅ唨\ꮿïs7ý˜ÆÜî¸z™Ô¨‹Ð3°Ø¿ÃÝô}î¦ÿ1 ÆØ#±iŸÍ/.BÁâ³î† ê·¢TjÍ\Òý°€6ÆBÓÌ 2NîNÝYÑVËò-ðë÷¹›~2~-{ůËS,¾‡‚Åïp7}Ÿ»é2„mÎJ£b³‰ðEè!XœøÝDk+ñ⪙2“î‡%²‡ka¬3MåEŽôƒñe,ã–žªQû>wÓoBFÝ.ÿa›Õ¨‹ÐC°øî¦ïs7}˜ØTm09ÆFúßCÁâÄÊ$\ºKïÙùÅx¸E%À½ˆö¤5ªgeRÏFꮿïs7ý&d<~Jt¦Ê­Õ‰uz¿ÃÝô}î¦A(¬¨%¶*þ§É)¾‡‚ÅgÝ Uì,FÝQv~1öhŽëu“ì9@my!L‰¤î4ú>wÓý–DYü–EÙªÏöi,BÁâw¸›¾ÏÝø dJ©bæn&º›EèXôgÝ Q…;Ç¿iMÝõÿäÅýb€©iIÎõ³t°$=êÙ˜œüÏSô}îÆ‡q“(>kt¨¬“êfzý;Üïs7~2Õ»&4ú©>y£.BÁâ³î&Ðe8ã¦_Óþ¨„¥Z¢Å²µ­â_yQ n&5*d+žº_ô}îÆ‡˜¦E§ñîfz¿ÃÝø>wãòï&°•ø77Ìi,BÁâ³î¦º4áȉxˆ¿òbT¨WNŒ*Ws»m"/F§X¬Ö‹ÇMaqŸ»ñabS™åtŸW7`ñ;Üïs7>Ä4]Ñ×'ŠEè!X|ÖÝT55Ž/ †³þ¨ñ0Æ¥3$Gɼa PÔõ¹™)ßçn¼ÝM ÁÍ=PÜÊÌccz¿ÃÝø>wã7!ƒ µ0v3Õ™ÂzŸu7U0˜a rÎÎ/VÐþ^ks³ÄåòV¢dcí’›™ò}îÆÿ,þŽ0*ñ8"›¸-BÁâw¸ßæn¢‹…'_êDt‚Ïýâ*ô,Öÿþ,ò".C›VŽ?eç+FàE1Ü_ZR «ˆ`nRJÍp7÷ç½wŠCLoŒF`¨\Ÿ±¸ =‹ñK~‹÷ç½wŠƒqøÖîoÌÉ)¾‡‚ÅÉž©Ò{ëp)šóظ†P ʺZ¹%u7ØÃ!ØáÜ"/zÆ«øþ¼÷Nñ&d¤µŽîâjÏÜÍ*ô,~†»¹?ï½SË£âûVº^’¨Ùõ=ô,>ën`þä¬jk’õ ‡±u"ªÜ€r6/ª÷Ò WM× î¯SÜænj„Œ'væ¤ë_…‚ÅÏp7÷ç½wŠÃÄneÛӪϊUè!X|ÖÝ`ô¹ö(­a—åQ öwئ™fšÍ+/bº#ŠÜ€#ÛZÌúë·¹›x[ÜÂ6Å~¹æÑBL”Œ«ÐC°øîæþ¼÷Nñ&d †"ónñ¿=3p«ÐC°ø¬»ƒ~qÔÕ0HÌæE “ƒnÉ}$ÔVÉÄ+,W£ns7QDß…'ãÚ0ªáâ:ë4ÞCÁâg¸›ûóÞ:Å:–G±ÄKßó&wý«Ð3°XŸu7… {ôŠÅpåžÍ‹TŒ¹ZáŒPàÊ‹‰²ê5·—øþ¼÷N±Ž¡ÄŸ¾êýüäßCÏÀbýwS÷¹›z2<>.³~qzu7î•0&Q-R“ãyʋƋ z÷ø»ì?|åE(\°7ÉkƒŽ_§¸ÏÝÔa@,Õ¶Ì"¸Uè!XüwS÷¹›:¡$^ûŽRŽ&›ÞW¡‡`ñQws­¦¡¥5,^cñlaÉ2_yW›M»÷xC®«~â>wSoBÆã!BÖ›œâ{è!XüwS÷¹›z2ª52^³ÎX¥ô|Šï¡‡`ñQwãÍZ©~5»×ª¨L^læÔ1žR[±l^,„:\Ç+çjÔ}î¦þYü-xåö'w‹ÐC°øî¦îs7u BEʰxSJ±>áQ¡‡`ñQw¶PM=~s§R’yѬ£ÎŒ2“‹' \œb…;ªa3[¹¼¸ÏÝÔ›qxGF7¯µLóâ{è!XüwS÷¹bš‚Ù`…¸äù¡g`‘u7§€’|]íÚ0“É‹`ýŒkh./VXlÄwË*u-fýÏS¤}î†êKåÒKͳ6|zé;Ü ís74ÒÚª ÇÛ{ÂÀ-BÁâ£îÆÁúœš8–[dóâu…CNRš%¾òbgÜÈBÿ…DªF¥}î†þmbƒíÉÜŠNf¦V¡‡`ñ;Ü ís74™è…èÊx2ãn¡‡`ñQwãÖ´PÁ°Füú©õz¸UlŽÞ¯^zÔL^l=*ãnØéäëÍ¿NqŸ»¡±<Ê«º Æ–}Òõ/BÁâw¸ÚçnÈî×$«ª ÏØðEè!X|ÔÝxÖâJ5’9¬–ry1*höC·L)îæ‡$é…*´ô9,îs74†™– ËÄccz¿ÃÝÐ>wCÀ¸÷kœîÖ“ûÅEè!X|ÔÝx ‚«aid’Gm,Äçh%u§¼X»•Ö[4Øem"÷ë÷¹Ë£åpƒը`ñ;Ü ís7\†ý‰ €‰÷™uzy¢»¤,:ÅYiÊ{êçarW˜£FnÍénj#ŠÌƒÈªk%ìž"ïs7<¡$Φy4ƒâ“7ê"ô ,òw¸Þçn˜î’¥÷6F`æ99Å÷ÐC°øìwS‡é<ÐØÒs‘O)« jr®?ò"Ù5­eñ©¥jTÞçnx B]ÚDƒ–fÆ£.BÁâw¸Þçnø&dâ}‘G1¦}Ò/.BÁâ³ßMüþJF½·|^,°»×¨3±-—M…p¯™µqÕ¯SÜçnøÏ T¿^°¹šÜ/.BÁâw¸ÞçnøÓàås¹²Ì°øzŸýn Äá\~Üø³~7Ö¦pM‹¿AÖï¦Ö޶rIaKfêýyïâ„jÕã ¦ðdNcz¿ÃÝð>wÃc ­h0§7Ãâ{è!X|ÖÝtÌ[wïYÝMÇzï®ýêü’zT¬ €G·Y‹—Wj~‘÷¹&6®Ú ÖnR'<ê"ô,~‡»á}îFn1±–ªpJãÉFÛUèX”gÝz|(ñ[ãÊ>3jA?s<juâ”.ò¢x-0‘‹|¼1üøŸ§(ûÜ â_žâ=:Á w³=‹òîFö¹ù#¦)Q¼Å‹Ÿ¦5ê"ô,>ën¤—æ_;öõK&/J§Ö5’#7Ë<|åÅø˜JÃr«Hëms¿NqŸ»‘a@\ôÚ„;×I^\„‚Åïp7²ÏÝÈ0 n E?_§§øzŸu7Œá ìR¾Œ“y‘á<£â(8kJ‡¥ÆÑÕîØ|un ‹ûÜ 1MÃŒ%;um6|z¿ÃÝÈ>w#7!Sn0&ð ˜Ü/BÁâ³î†•z‹÷G«Z(!c£Ÿ‡%:«¯8ñžò•ÙÛm°ßªå¸ÙçnäßÄÊø+69Å÷ÐC°øîFö¹¹ ƒ}hÔS>›_\„‚ÅgÝM½¼QÍN½$F-èçaÌ-6éL?-_*/‚B­iQKîNCö¹ñ?ÉN<þ{‹|7{£¾‡‚Åïp7²ÏÝhähµÞ¡î2aág`Qu7(LfK¢[”–ªQ¯‡;¿Fˉ©¿d^¤V¡2s, ÏÍLé>w£CLSø2]ÀðD=µ=‹úîF÷¹½ †q(P„hÂÀ-BÁâ³ßMéb+f®±Þd^,Ý´FÃé&–õ»©X6W0+¨Ê¹U÷¹åû5Y stò•ñ¤ºY„‚Åïp7ºÏݨŒ‹ s¯fštrŠï¡‡`ñÙï³Àìï¢ñû'ób¥hújd*÷ìœFTÇ…+»y€+¥ ×}îFoBF¢d!¨i„g3S‹ÐC°øîF÷¹‹¿µstÜYf<ê"ô,>ên:Æ¢3gîšì;,š"364œ%;§Q ÅçeNÒ¤f‰uŸ»Ñ›©=|`9oÒ/.BÁâw¸Ýçnt BÙu_ØKO&§øzu7Ý ¾z‚ñgÍÎ/ÆÃj嘂Ò;™K×R ñH@©; ÝçnôÏò(æèˆK‹Ÿ½QßCÁâw¸Ýçnìß„ŒÇm:9ÅEèX´GÝMï‘ÍŽÆÞ#Á%óbï½bÃH$Ë£b¤Å¢O­Yª_´}îÆnB&^%´(§g{¦¡g`ѾÃÝØ>wc7!Sà!Ý C³¹þEè!X|ÔÝôì»[ËêQãaødI8SàþäE˜2J'üøõǯSÜçnìÓ¨ì Ól<»%^„‚Åïp7¶ÏÝØÓÆ] #sL&ß¡‡`ñQwÓ­H¯±sÊ{êzؤãi4YIÝc¢xa×ÿ:Å}îÆ†qü¦q(­›æÅ÷ÐC°øîÆö¹Ë£âkŠy}/e6׿=‹º›ïf-êD)&) <,USµIIö‹~¹ÇW¾G>^ߦü:Å}îÆîA(Š7޹rÕ³™©Eè!XüwcûÜÝ„ ®À Þ,B³[âEè!X|ÔÝD“h°ín×-a–GÕ¨L+”©É9§cŠOïr,_>üë÷¹» ™€–~Qbžhࡇ`ñ;Üís7í&dÁ‘K›Ýõ/BÏÀb{ÔÝtŠ~¯«öË Ë£ENSpVR4™»^fÀÖÝ óR´óŸ§Øö¹›6Ä4—ñc´ò°õ™œâ{èXlßánÚ>wÓþ,þ6iØÿ¥2ãQ¡‡`ñQwƒ•XQ¦Z3woÉùÅxjàFQEÄÏ•…œGoæÑ:,þuŠûÜMË£<Ò\”,ѤÎî4¡‡`ñ;ÜMÛçnÚMÈ f±kÐNur¿¸=‹º›^Kã.BUñû'ób-ýÚgª^‰“<*Æ ªRu7ªe™‘â>wÓ†‰Ä/Ø;Å¿fÞS‹ÐC°øî¦ís7í&dŠ6.ß8g›¨§¡‡`ñYwCÖ· =PAÙ~‘Ì­c5 Uɘ«þäÅÊñ3±Z‡!È`qŸ»i7!€¬yŒúv6¿¸=‹ßánÚ>wÓnBFÛWJ÷;ÞçS|=‹ÏºÖ(2QX ¶F&ób<ßY)…kµl¿È—#€FoÍê¹¼¸ÏÝ4ÿ“ìâLz ÜϼŠ¡‡`ñ;ÜMÛçnú0±Q*QŒy|wf;¡g`±?ën¸âÍIŠ OæÅHlxùDÓgñd^$&,_¤‹îJñ¨}Ÿ»é7!Óâϧ\Š[™mî[„žÅþî¦ïs7}ˆi¢To­|ŸäÅEè!X|ÖÝ(f ã‘“{¦@…­ÞÝ™Jj· úE“jQ!SäENq7}Ÿ»éÃÄÆ± Ë¢ƒé)¾‡‚Åïp7}Ÿ»é7!ÃWãèåi–ßCÁâ³îFOF@Å=ç±q=|)RjüM’s=ZL5oQÒË),îs7ý&d,þ„ÑØ¢9í%^„‚Åïp7}Ÿ»éÀ˜µÁL¢7Ö ·=‹Ïº›ÀbÓ^.¨ôœÌ¥ÿ8丛ò«PÕGJn²þÉ¿NqŸ»é7!õ7Üy VÜÍNñ=ô,~‡»éûÜMƒPØÝ^±'[ŸOñ=ô,>ën)­8¬àjz~w!Ñí:¦ujû/ïCŽ·V$ÆB)µïs7}˜ØÄÙ֑Æ`rŠï¡‡`ñ;ÜMßçnü&d¢30öÑÜÌ4p‹Ð3°èϺ‘J0Y–ÒkNôó0qüÖ¼Dß—Ì‹uU Sºßçn| BuìB¯56ÛK¼=‹þîÆ÷¹„ŒÂÈ_T÷Iu³=‹ÏºLëE¡yíBmÙùE‰$)U¢ák=y¿Ø_éBñôZ•þë÷¹‹¿…#íCó]f“o‹ÐC°øîÆ÷¹„L-%J±Ö¬Ìô¨‹ÐC°ø¬»±ZEZ×^•s^Å×ä5êòÈ$^“¾á­F-ׄãcKaqŸ»ñ›A)}ù?ÚtÚfz¿ÃÝø>wãcªX4S0Õ-3OÆEè!X|ÖݰG&ä¨ð$Èò¨ ]*¬5ÞAü­‰~Ñ®œšÄâ>wãcñw®z:N/BÁâw¸ßçn|2­Ä›ïþ¨ª&§øzŸu7âä¬ñÝ뢖҆_³W¨J¡IMiÃË?¦•°W‡+U®)Õ÷¹ƒPŽ’“ÓuæU¼=‹ßán|›»‰å¾PŽÐõ¯ç~qzé¿?ËŸûÅÈŠñ'h­*³ý¢2˜PÆX-›É"ý˜a¾_û’ÁýS¼?ï½S¬w+ßZtµÕ,÷äßCÀbü’_Áâýyï" a›†/>“S|=‹ÝMtE£¼v̲gï Þ…QÒIÕ–Ôݪ‹Ïªq4g™;ûóÞ;Å!¦±ÿ‚KV¤¼É)¾‡‚ÅÏp7÷ç½wŠ7!C&ŠeöŽQ¨É)¾‡‚ʼnîF<þI@¤Rv~QµÀ½ÞÌÉõ_ÿhL˜Aù™¹Ó¸?ï½SÔÑ>hoñÏ?ìyòmz?ÃÝÜŸ÷Þ)Þ„L/×0a’aöF}=‹Ý E{dõÚÈ#é¼HÐÁ_¦7’õG„LŠQbŠRÐ2ÚðûóÞ;ÅAÈ€OS,ѱ‰ãô*ô,~†»¹?ï½SƒPP|s¯Ä4­nÞCÁâ³îP¢†Iv PdyTldª­k¾1U£F^¤øªŠå²~ø×)ns7Q@ß·@ãWH¦ ÿUè!Xü wsÞ[§XËí{·¨W°òd‚ÅEèX¬Ïº›fÑáJíð%ób³(R9þ Z•d^d\hTi½Ä¿¥úźÏÝÔ[L£XE®ÊÚp—ù|Šï¡g`±~‡»©ûÜMË£¬x¼'[¯m¢[…‚ʼnîÆúu¿RɬŠúÑݘÛåÓ£VMú†GX‹j<ÿ¶þÉ¿NqŸ»©ÃÄ&Þî­)£±}>Å÷ÐC°øî¦îs7õßÄ}`煉)ÔUè!X|ÖÝ`6 ¥µìôW^Œ‡;Í×¶Š¿OQºz‚\->·”õþ¼÷NñÓpLjwãËõnrŠï¡‡`ñ;ÜMÝçnêŸA¨ŽmÖ¤¥Mv¾­BÁâ£î¦a-MTcñT2£ùôóp´ÆØ‹ã²{¦DɹÔkõ[/™YâûóÞ;ű<ª´ªNŽAäÉ-ñ"ô,~‡»©ûÜMÄ%^ß½T”T³S|=‹ÏºŒKqtF$"ë›…¿ò"n#°è5¹¤°yQpóí‘EœË‹ûÜMýcbÙ[QM÷ÉηUè!XüwS÷¹º –Æ® ƒmöF]„žEzÖݯDñî¨Ô[fì‰î‡Í£ªƒÖh}-ñW^Œ*‚.ÞÆX5u§AûÜ ¡&j-:Á™bczé;Ü ís7D÷k2eLðƒ° ¾=‹Ïº›¢ ›¸G›KkgÄ¿ó¢êŽQ4±¬o¸ÆìbT© º÷¹ú³< »“µÖÞ|r¿¸=‹ßánhŸ»¡›‰T'åb¸£©Ÿœâ{è!X|ÔÝ4qwl1+¹g*:½B‘?¢Ñlž½_dà˜›öÎì¶¹?ï½S‹¿#õs´µ\£»œâ{è!XüwCûÜ bsµâñ—&õÔ"ô,>ên¢¢öÒ¼â—î™ÔF÷Ãl-ºÍøkJ^þÁR.굫D%‘ò*¾?ï½S¼Å4Æ?û^Ùdâ ¶ =‹ßánhŸ»¡1å Gý9»ë_„‚ÅGÝM‹ï^ÔˆEUTržŒ?3®U­DzKêQ!ŸóÈ?­ZTƒ©ûEÚçnh BÅëW(Žé®É)¾‡‚Åïp7´ÏÝð0 îÂÖnpw{>ÅEèXäGÝM$C–øm%Z>á”îçahþšJ 1É£’©`ñˆD³(k%ìž"ïs7\‡qFt²™üÙazù;Ü ïs7|‹i°ã¤FûТ»™äÅEè!X|ÔÝXüÆ• ÏŽ µf3çE<ÌÍ*8Ë y\yQ"#ZpNñ¨¼ÏÝð dèÒö6»ë_„‚Åïp7¼ÏÝð0±ÑËxK?ˤ_\„‚ÅGݵÊDRJ¤ôž)<ÌÝ©z£–Ý3½{$äÀ¡\vÇ),îs7<¡~ œM¶…­BÁâw¸Þçnx2‚C^¸Ó‹ï¡‡`ñQwc%ºaÀ?`Sìl’žÓ Ø9zÐ]%w¿ÈûÜ ßbšâ׊¹è‰Ý'7S‹ÐC°øî†÷¹¾ †å‚.Q‚Nîú¡‡`ñQwcQMnðÙÀ°W¶_Œ‡Šh•×Ò™¿òbõê¢%ÚFX—§°¸ÏÝðMÈÄ»¢aÍ©Æ[röF}=‹ßánxŸ»‘a@l5Þ¥²L§m¡g`Qu7¿2¾Ü¸h=A…ÒÏÃýR¢ö(êÖW„åÅâíÇtMÕs8Ùçnä6±!‰?`Ç^LŸìB]…žEùw#ûÜÐD5Â\Q£™ƒØ*ô,>ênâ[W`ëŠY=I÷‹ñp$q–èþ’>p‘L]¥7‡Ÿ@MÝõË>w#À˜\áÈìØq79Å÷ÐC°øîFö¹&6ãËÊÑÑG159Å÷ÐC°ø¬»)½6“&ÕŠIrŸÖ^¡‹Ü–åQ«E!hµií]S÷‹²ÏÝÈ„âV£l¦³uz¿ÃÝÈ>w#6FhÝ}æþ¾ =‹Ïº›Âì°G…yxRwS Q1jE0˜͋‚TÜã³ê–ëeŸ»‘±ø;ªp•‚mè“á«ÐC°øîFö¹ù³w£|·V9þ»Ee4s_„‚Åïp7ºÏÝè dȹ£‘Ç0ÃäßCÁâ£î¦‰¨0›–mc¶_Œ‡É)¨›œ‡äŨ1<ÙqÇ() Ýçnô&dõxgćj™tý‹ÐC°øîF÷¹µ!øvixïÇ·nöF}=‹Ï~7ò3< 37É\×Óý0KtŠE±M5›{ÓÂU[­²&aâ>w£cñ·i¼ˆ½¶éõ=ô,~‡»Ñ}îF‡˜F!Üçx—·=‹ºpV"9QAŽËÎ/ ¡ÂŒš.:Æt¿Ø .ùñ­§ms¿NqŸ»ÑabC1ì!j3,¾‡‚Åïp7ºÏÝX—†‘í°$°ñdê*ô ,Ú£î&R[ÁE ±kn–øçaŒÃ@2@¾ò"c““õø¨à\žÁ¢ís76¡ÒY(„âE99Å÷Ð3°hßánlŸ»±›Q‰‚Ó.ïÚÉŽðUè!X|ÔÝ4‰&7ê2‡p†³wcƒ~Ù££¯uv¿¸=‹º»Ø&¶HmZsþ×èåwcƒ‰ 5±Ad4ëúßCÁâw¸ÛçnÚÓÄkX`Í_±bðñ¡g`±Mt7¥EÇveÇâY8<ÜŠPUÖžºëZá>Íê‰ Û>wÓnB†ké5:Óxu̼Š¡g`±}‡»iûÜM» 8Ø0öÒGÍ2éú¡‡`ñÙ囹á&¦¡ïËŒZÐxXZý1gNúÀÕh­9šT÷“ãQÛ>wÓ~¬ü6!'ø ÌNñ=ô,~‡»iûÜM» ™SwLÒà„&§øzŸýn¾g¹Mâ-’ô Çà qìQs5j|\Ú7@ñs™’XÜçnÚMÈØµY¢òluÒõ/BÁâw¸›¶ÏÝ´›Š×w¼ý±;b¢ _„‚Åg¿±¹­w/ë÷¿òb<ŒâVöÉ~1ZjÂ=¬™ö sÕ_§¸ÏÝ´±<ª–xk‰´7ÓÀ-BÁâw¸›¶ÏÝ´~_ýÆ×”Uk´‚6Qø/BÁâÌï†0Ix4ÊÎiàá@qëýUOêQ±™ÜŠ•‚ÙÉ’âQÛ>wÓîÅßR8ÚÓ@no&§øz¿ÃÝ´}!‰28Ákqv3µ=‹}¢»)µt”dîŠYÝ §±£‰å´á‘ÉÔâëN¥y_\ýç)ö}î¦×a V[”áÑkŸâ{èXìßánú>wÓoB¦vdºèˆ\gJÆEè!X|ÖÝt‰ÿ³‚µ¤’½_ÄÃÚÙK%öÌ€Ÿ¼R´OÚzyã¯SÜçnú-¦1ìU”fÖËÌÍoz¿ÃÝô}î¦ß„L´3áq CˆÉ)¾‡‚ÅgÝM´ˆ½Àp^o^û+/ÂUD™Z‰²<³ÔøÊ‹U®c JµqÕ¯SÜçnú d¤G­Buøl»ô"ô,~‡»éûÜMÄ]¹´¨ß¢)šâ{è!X|ÔÝôR]HÝ©Úÿû«×(˜5•ÔÝÔ 1[‰¾L)¹#¼ïs7ýÓ~±H+ºù©Ëí"ô,~‡»éûÜMbšø®Œ¤g÷‹‹ÐC°øìwÓñëZÀ +»³{¦âaÒ JéYÝM<‚¥Ø‹£X®ö¯29Û‡SÜçnúÓh$¹\ fs‹ÐC°øî¦ïs7~‹i°ÿ«Ä›_Ùê‹‹Ð3°èϺ›î‘º1 6gûE7ç@¡þh7Sy±ab‹ÇµÂ¢#ƒEßçnüÓX dúQzN°¸=‹þîÆ÷¹¿ Á¶O)Ta[89Å÷ÐC°øìwPèõÚôDš‘ÎÐý°aé›zfò¢ÄW>‡"fSXÜçn|2µÝµÊ|Öõ/BÁâw¸ßçn|˜Ø¦ ÀrËL¾=‹Ï~7½UÖ¹¼D6OŒ=ýäÅV`äÆè±Öòî¿u7?Y½õîUSXÜçn|25jÎÓ9›yO-BÁâw¸ßçnÜþmœÑ/ëZšÝL-BÁâ³ßMÃîéXþY$©»ÁÃ* Ó-æž0®Â)š¶Öp?áÒ¬¡S•íSÜçnü&dK , eæá¿=‹ßán|Ÿ»ñ›)\M{1e¢YuózŸýnZ±Hå­G‚“Ìh>ý<¬­ŠÖsÖc.¶iÄ ’¯Å8ûyqŸ»qÃúÑͼzT-³7ê{è!XüwãÛÜ —±<Š[‹ªI«“™©UèXäÿþ,t7?[”,é¼(Ý"§¢Æm’1èÀ)Šq«%~úEÂîbñþ¼÷NñÓÔ0ÌìØøú|Šï¡G`1~ɯ`ñþ¼÷NqÇCÑõ"³›©Uè!XœùÝÅEýu–ÂâÏÃT£–S.im¸U6Òî¨Ë%ÚÙÇâ6wÃå&dâD.÷ÉmÛäßCÁâg¸›ûóÞ;E²}ëͰGê3¾ =‹Ïº\h˜Åï[pߟݧ D±.J»prfª¶¨^.?;…Åmî†ËMÈôhþ$Þõžâ{è!Xü wsÞ{§x2Êrm´7žm(Z…‚ÅÉž©èôc#{Kênðp‰ÙáÒáIÿǪ¢Ñj:(Ü·¹.À¸‹5†^Ol–ßCÁâg¸›ûóÞ;Å!¦ãÎTËÅ0<Ÿâ{è!X|ö»éZFnñ&±õäÒ_ó‹ñ0™©Õ.›1!RJ¯æZK‹ÛÜ —{ªªöꑃ_³Nã=ô,~†»¹?ï­S¬7!ƒÙs´T®ñ®|>ÅEèX¬º³VVnÚ¹f¬¿¯ùÅø£ºŠ6bÖŒ˜õê1‚Œµê¦è¯3X¬ûÜM½Å4bP$/¥Mî4V¡g`±~‡»©ûÜM½ ™‚Îû"šÓäº=‹Ï~7JÍK ¥Xú–Ì‹ñp$‘h5»%ˆœbäbX2Rcã~]NîcqŸ»©cyT´¶£9í¤“Ncz¿ÃÝÔ}î¦ÊHvÍ1)ÅçD· =‹¿6 %D:ÎÈØè~˜ÑìIÍÍiüë4dÞ»ªuÀ1…Å}î¦þÓ€‰ì­ÒŸo‰W¡‡`ñ;ÜMÝçnêŸA(”qQ® ¯™œâ{è!X|ö»!댤·œŒî‡µ2,EŠQ2/б—(r¯1úÔœÆýyïâMÈD¥ÒË-^˜“S|=‹ßánê>wSoBFË´£Ÿšañ=ô,>ûÝTèfÈÝ“¸Ÿ‡ãOÝ"µÁ6—¹Á[¹ºy²_Üçnê-¦1Uwïñªì“YâUè!XüwS÷¹Ë£joÅg)Òž}àV¡g`‘u70è‰jÑÕa˘څúó0µ 3o´\Oóû©ÃˆC…9Ç£Ò>wCcyTQʃZ“S|=‹ôî†ö¹ƒPs&˜föYu³=‹º+]•H-µ*Šî‡£­‚ux³µÅé_zÔø™½Jd±3zÔûóÞ;Å[L£ëôµÍNñ=ô,~‡»¡}î†än"et(S¢¥šT7‹ÐC°ø¨»± qv¿0%»g c áú·äœF-Òk…ÃzAϘÂâ>wC7!£‚mät/On¦¡‡`ñ;Ü ís74 ˆÕœŒÅ!ÍjÔ÷ÐC°ø¨»QÈ¡¨ gu7x檃SÉYb8²b‰Lóh513uÞ{§8–G™D±ÂøôI׿=‹ßánhŸ»¡›¡kN¶h¼½'ûW¡‡`ñQw£ÍºÃŸÔ‰JKênðp‹Œª•[´âÉ»~l_U¬(/WRÕíSÜçnh˜ØÀ­N n«S,¾‡‚Åïp7´ÏÝpW¿nR\±C{r3µ=‹ü¨»Q˜‚Ä—›(¾šô ‡¹I$T`¹¥òbùÇáÉr­n¬×ÌÔv^ä}î†oB¦Eî'ˆ 0 59Å÷Ð3°ÈßánxŸ»á›á¨¡\Éf[QV¡‡`ñQw£VJ«X§ìÑ %ûE< 8܋ךâQÿi„šaÞ3ŠdIq7¼ÏÝðMÈtаŽ'Κ«ÐC°øî†÷¹¾Å4Š‹{ãøâÔÉ>Uè!X|Ôݨ\SOñ×®=çÉøóptXÄѨ$ó"À¨uL3×ÔÌïs7¬wÉÒr¨ËœgöF}=‹ßánxŸ»á›‰¬-`ïÍîú¡‡`ñQw£â¢ã³Bœ±á§ûaití‹ê¹¹~p7sØÞÜû4ö±¸ÏÝð dJ¼#©Š×h &§øz¿ÃÝð>wÃ7!S±1ZÜ”§w‹ÐC°ø¨»‰2ñZý©½Iò~³P·î–ZpyOy€RØ(V‹¥î4xŸ»á!¦qr˜sD¦Éüâ"ô,~‡»á}îF†1]¾Ø¨ã|’¡g`Qu7)M#5j-…²s×ÃÝ&s,u¿ø¯PGbÝ0Ê‹²ÏÝÈ dØÊEÈpœÍäßCÏÀ¢|‡»‘}îF!_“‘âìNczu7Ú;æº4ö–Y¡HãaŸâ{è!X|ÖÝ`SL‰r‘±1;§‡90…ñéwsí™Ò)éë ‘_§¸ÏÝÈ-¦‰¼Í]±F¹Mv¡®BÁâw¸Ùçnä&d*²iÔo\úì–xzu7VXE\<ŠEÊæE<¬×zìDMò¨^$—+£¹K‹ûÜŒåQQtpůÊÉ)¾‡‚Åïp7²ÏÝÈ d°^°A„Á³YâEè!X|ÖÝxñ"­y XxÒ|Ã{+%;K\) ¨XÝèÜËò'ÿ:Å}îFnBÆ£±uS…~Vݼ‡‚Åïp7²ÏÝè0 Æôè‡àø|Š‹Ð3°¨Ïº¯Ô µèÝL2ònúy˜‹á.‡â˛΋Ô[kj*‘SXÔ}îFoB† f„hÖúD¾=‹úîF÷¹ƒPWKÓ°~ˆ'5ê"ô,Nt7ý§®.Μ«QncÈ b“<*öŠGn$qïBˇâ>w£Ã€¸ã’¢D×™÷Ô"ô,~‡»Ñ}îFÇ T75¬®QºLNñ=ô,>ën¢¢ÆÐsµ–AüÑ£rTŒeðrËæÅŽ®¬DJaqŸ»ÑabÃBÖ­DÍ2ó _„‚Åïp7ºÏÝèÓD)efZe:ù¶=‹Ïº¥¨ ‹b³eÖ™Òý°vޤZÉJr–8òb$UXæQÛ(pâ>w£7!sÍyKuóßCÁâw¸ÝçntGÕ‰k´è¨ú¬ºy=‹Ïº›ø•Ùèê÷8±(JñÅe,Jó¨—I<^´,…å¿NqŸ»Ñ›i—ƒ€G%.3…ÿ"ô,~‡»Ñ}îÆ†˜¦baD1*e6K¼=‹ö¬»Q‹órêÁB—l^´ªê× $åv„_÷‹Ñ1ªW5g°hûÜ BF´Áåœ0û<9Å÷Ð3°hßánlŸ»±›íiõ•”Nö/®BÁâ³î&Ú=Œå “eõ¨Ê°÷‰ê–JOó¨ñ¹aÄLµ”ä†ís76×*"ÆÑÑËD=µ=‹ßánlŸ»±›Á +×JÞmÖ/.BÁâ£îFÍ£Nt'‹ìfÙ~ÑâO*$Ò˜S Æ‘#{w+µzä䔜ís76–GagH‰ÆTêÌ“qz¿ÃÝØ>wcÃÄ^.àýµÍÜß¡‡`ñÙïÆªco¼GˆKVŠÉÅZ u&eób‡ø-ÞYµ–N—Kò>÷¹ÄÕâOY¢^é³®z¿ÃÝØ>wc} %bsKÃÝá4/¾‡‚ÅgÝVáæ$[jÒ™Ÿ~1z>1 c9T,o,ñ€Xa¯9,îs76™vm^nq4}öF}=‹ßánlŸ»iÃÄÆ³›©EèXlϺ›k‚ŠÔÚ)³žæî¥H4}Íp©šÜmÓjqòËs553Õö¹›V‡l¿á¿Î&ýâ"ô ,¶ïp7mŸ»icñwL×㟳¹þEè!XœùÝT§®^ñIën y`J 5¢$ {è`;E ÊíoûÜM„ ~H‰ßÖÉ)¾‡‚Åïp7mŸ»ic Û ýò³I׿=‹ÏºEÓÍbt}žö»Ñ(ÈùZL,žæQá*; ó(îSÞSmŸ»i·‰M‘GœOü!gn~‹ÐC°øî¦ís7í&d(Ú‡HwŒ¯À¤ë_„‚ÅgÝ nÛ ×î.%Í£6¯ÑXAªÂ“û4"—F[ï­H­?{¦¶=Û>wÓÚ0”Š.32pí<Û¢¹=‹ßánÚ>wÓnBF.âUÏ&ß¡‡`ñYwã¯ÿJÒY2pºç4ŠÖh3¯…ªIm89¶‹ ¼à®%UûyqŸ»i7!?§ yëÄ{jz¿ÃÝ´}î¦1M«ØqJBmææ·=‹ýYw­m7H¥ìþÅx˜«7)ÑYEe—Ü¿Ø{-^ »u~ãlc±ïs7ýÓXüª&6Vë„G]„žÅþî¦ïs7þ\ýFWÃÑÌ÷Ùuz'~7RE<ªÔ(¯Óó‹]Èk”RkËz_ß`BW°Ú8•û>wÓ‡1Ôñâ°2|[„‚Åïp7}Ÿ»é7!c_Õ-Dµ™ƒØ"ô,>ënZR8*š¤l2~úEÌYÀx¼bCNÒ{*~d·kÑTü[Ê{ªïs7},*æE”PŒOúÅEè!XüwÓ÷¹›~2Jñެ‚;išU7`ñYw£ÚȪSi¬*ôæQ;܈”œß ´áµck€1€¼TÂþ:Å}î¦âÊ.Å[ü0añ=ô,~‡»éûÜM&6°^¤tŸèn¡‡`q¢»q4_¾ÊLÙ¼ˆò{P=*\så¹§a¥Sj–¸ïs7ý&dªÆSE]DgŽÓ‹ÐC°øî¦ïs7þÇ€¸ÆÙÄáD[5©Q¡g`ÑŸu7°á¯d¤×eLvŸF4U]ŸÄ*ɼÍ'lü9Ò£¥ò¢ïs7>™†ÕÉñ#«ÖÙ)¾‡žEÿwãûÜA¨Æ‚^>º¢™ƒØ"ô,Ît77ä‚hþÒy±u4ŒbÜ2 Ư¼Øˆ;¦“*|Ö—*ƒ_§¸ÏÝ8ßøÑ6`•ŽÊÔ{jz¿ÃÝø>wãcyT‹æpñÍÍäßCÁâ³î\SÁ_j¤©ô> ,¿(X1ÍzOuW‰RBÙ}ãrò×)îs7~2~yÔ‹òL„/BÁâw¸ßçnüßboî?^D“S|=‹Ý äoÑíµ¨­3-ßÍ£ ö™F‹=_ ‹å*pi¥y“T¿èûÜ·!lƒþ¢ˆtª³S|=‹ßán|Ÿ»ñ?&6¥DÝi=J¹YúzŸu7ýr7mQ½÷Ôuý½O¶ŠXS’~7ÿú‡à D"ÜÖ¤°¸ÏÝøXø²½69Å÷ÐC°øîÆ·¹)7!ãÓÑMa{ôã)®BÀ¢ü÷gy珩‰j—ÌzšŸ¼HE¡m(¨’<*ÕZL¼_óV%ƒÅûóÞ;ÅabC=šZÑÚáçñ|Šï¡G`1~ɯ`ñþ¼÷Nñ&d¢„3ø@Äÿ³S|=‹Ïº›Ö.,ziZÒ¶¾¾ùÏS¬ûÜM­Cð S° b›`qzëw¸›ºÏÝÔ±ø‚ îÅžo‰W¡‡`ñQwÓºÁ”cWTRwsüy-þ¼•[¶_,ðï÷ëfR-‡Å}A¨R4Ò7˜¢‰nz¿ÃÝÔ}î¦Þ„Œ‹3ö ×Rûó,ñ*ô,>ênЪ‘]þÊ%9¿ˆá\"±i¼~ÖôË_º›HÅñ£1Ql,BÁâw¸›ºÏÝÐXü-Ú*VÒ‹M¦PW¡g`‘u7{Ó±iŠ£f¼<'gû”+VSÅ"ê]öþñdTì*0øˆ¶3ƒEÚçnhˆiZucL.÷™zjzé;Ü ís74 ˆq­p…é“ma«ÐC°ø¨»©…FG _-ß6ñ°–ëy¨®ùÅm,b~±\ÞªÖ£$\ÿ:Å}î†xÛœ˜ ÖwLþ«ÐC°øî†ö¹&6ÕÁó• ¯´É)¾‡‚ÅGÝM-¸ÖÖ®"QW{6/š©Šzü‘½fó"¡a„ÅG±ºÞÂúë÷¹º¡¢^Á†xgó6éú¡‡`ñ;Ü ís7t‹i¢~*0¦ÖfX|=‹º›Š½4TpŸ!zm$ÍäÅx8RbÅN¿ÖÓdòbô©C‹ˆñµö×)îs7ôgª°Õ‘'§øz¿ÃÝÐ>wCÃĦµÆ†Õ/Õf§øzu7˜^ŒªZ±íI,'ºî§Ò{`¹'óbe/¸dô@Îõ‹ûÜ ù ¸Ý­) vê¬Óx=‹ßánhŸ»á›‡t‹ãQãɦ÷UèXäGÝM%QÆÆAíö#)ÍäEYˆŸÄÃW^ŒÂ-ÒP|óµ¦ò"ïs7‘qËmµ4\Ʋ'¼ŠïÏ{ïÇâoŽŸ÷aï“­(«ÐC°øî†÷¹¾ ™ZâCq>Ø+?9Å÷ÐC°ø¨»©pžjÉ­X¾_dÃý$Ç?„2Äϵ#Ü%ÞÑZ;$¼œÂâ>w÷˜Æ;³vœSŸL¾-BÁâw¸ÞçnxˆiÄ]u|mfX|=‹º›o¡øêu*?~7™¼·è¯0Ó ”ºÓø×?Ý¢ /=÷h59³Ûæþ¼÷NñÏ E'_#¥ê‹ï¡‡`ñ;Ü ïs72Ä4Ñ;hS®Eg<ê"ô ,ʳîF°Î°E«hÑ8&àD÷u}౓.F’yo¬øÉ¸hR/,Ê>w#uX.TnXbE'Æ"ô ,Êw¸Ùçnd˜Ø4xAXNvÛ¬BÁâ³îFD#„î½öTúó°ãr\*’y1~"[ïDØÈaqŸ»‘±ø)bpUnz¿ÃÝÈ>w#7!Ó¥cÚµ€c˜¨§¡‡`ñYw#0d”V®å6YU¸@(Ö°áÞ“yÑ£”øÎ³”(ëSÜìs72Gæa I§±=‹ßándŸ»‘±<ªâûjQMÉìNczŸu7ÒšânQë¾³y±ý¬wU+ 1ëÏýb­‘€”¨k©ûEÙçnä&d8ò¯1¦Q¨Î:÷ÐC°øîFö¹¹ ÒR½ÄÛ› ×|>Å÷ÐC°ø¬»‰T~ »K-'ºŽÇ±£›q²÷‹ŠŒhÑ®jü§÷¹ñ›âŽn¸ÕRz¥2Q2.BÁâw¸Ùçn´ a[wfq6Ùh» =‹ú¬»–]©Ç?#dõ¨ØÆá°c¬‘Ý’wÓ†˜½ã †ú‹‹Ð3°Ø¾ÃÝ´}î¦åQÖ0M¤ð矸3,BÁâDwSQ“U•é1Ý/â2ÃÛ%ÚéyÝMm(Rãcã¶\÷ë÷¹›v2‘€›¹w¥6s[„‚Åïp7mŸ»icy”ã›Ö°—o¦d\„‚ʼnî&rxg‰”Þ~6’¦òbc\kx 'ÓzTº–r‘¶žÚKÜö¹›v2NŽW¤@Ç>Q2.BÁâw¸›¶ÏÝ´AÈa«3^á“S|=‹Ïº›véK"¿•Z326úy8 \vÂ2˜–ô»‰W´cY¥²””î¦ís7mGoZØ:¡‰’qz¿ÃÝ´}î¦ 1M'éñ]åÚÚ ‹ï¡‡`ñYwÓ<:#,_4§žÓh÷oªµ"SXÄýb£È‹X!ãÊ)ÿ¶ÏÝ´abC 8ÊâZgw‹ÐC°øî¦ís7½Œ1ï.Ýãd4*²çS\„žÅþ¬»éÔM…µWÕ,oŽ"¦”ãn.=jå@a<Unê~±ïs7½Þ¯IÆÊÖ&=~Üä®zûw¸›¾ÏÝô›iVâË&ïÊ™ªxzŸu7pWv­Þ:gýn"ùrkö~1>)­ŒqAxu§°¸ÏÝô›ÁEQ,`†ÿãó)¾‡‚Åïp7}Ÿ»é2d˜Zç^¼ÎjÔEè!X|ÖÝx¤pÅëÉ÷¹›>ÁnÑ™Nóâ{è!XüwÓ÷¹/ƒÅ^Ej‘<ú¤_\„žEÔÝ`‚8:$ô`¬œÚ~=\‰k¯îÅr3S0®Šlc”ë}Ÿ»ñ?&6dMšE0Ó£.BÏÀ¢‡»ñ}îÆoB&¾§% %‚K´É)¾‡‚ÅGÝ UfÁŠBzJañça‡˜“·œ½_ŒäÓão€i­Ÿ-¬ûXÜçnü&dS«R[åÅEè!XüwãûÜ˸ÀWÇ27õ@ÚäßCÁâ£î“Rõ’'p«9møÏÃjHÂêÉl^„É:Ã;+ŠÁ ÷¹‹¿¨0É¥ œâ{è!XüwãûÜÿ2ó8¨L½–Ùê"ô,>ên›b:–ðjaÎö‹0b¯äQRvN£ƒá’@"®úSs¾ÏÝøMÈ4Ž·wÔ}r§±=‹ßán|Ÿ»ñ± ˜«ÌìFýc–³Åmî& ï»ðÄÞé‘ëhR£®BÁâg¸›ûóÞ;Å!¦¹d4.Èv³7ê{è!X|ÔÝPÕkl)ª2ךÔÝàa¾ 5y•”"V±/Ž Ûϸ},ns7Z†‰MÓÊ‘ü£1¦gnz?ÃÝÜŸ÷Þ)þYT/]¹O”Œ«ÐC°ø¬»©ŠÙ’ IR+Ù~1îÞp5ß´d^Œ‡8²iÇÔ–J ‹ÛÜ–›évi õs¿¸ =‹ŸánîÏ{ïoB¦4)15ëü|K¼ =‹Ïº›HO=2Á(;c«H?7â†%Š­K¶_$†«jiÅ 2XÜæn´Ü„ c¢cñêLɸ =‹ŸánîÏ{ëk¹_“„¡×ªP(NNqzë³î†PcÖxH¼J²ºÂÕ`÷ßßš»Ó@^lèïäñ¹•wS÷¹›z2M1ã²¢×Y¿¸=‹õ;ÜMÝçnêXü~ æJ—èó)¾‡‚ÅgÝ q¤D»ìÙ³pÃꂟOñó3º›ûóÞ;Å!¦iŒE|âÑHÌNñ=ô,~‡»©ûÜMýc@ìÑ×”.ÑS=kÃW¡‡`ñYwxhU5`‘Ý¿k½L¶µöžõs-dBÞxÊîþ¼÷Nñ&d, Åýëm99Å÷ÐC°øî¦îs7u B¶ÑsWÌÍNNñ=ô,>ën*l2Z%,›ÊúÝàaí¥ aSIŠ»¹$ƒLjXæ¡­¦úźÏÝÔ!¦éÑl%Þ7¿Uè!XüwS÷¹›:™Þ•*w)3—ÛUè!X|ÖÝP`ð2®«¦n¥DéÍ=»O£õ‹sŽ„lÜ2¾á÷ç½wŠc*LŒý¤ÅÆ"ô,~‡»©ûÜ ÝbQ+ê0jurŠ‹Ð3°HϺh_L°ÿLçE0ÿ®ÌM$ëÚ™82r%¢wCûÜ Ý&6UÄ`È ƒôI^\„žEúwCûÜ ý{ªG±b ºšÉ)¾‡‚ÅgÝ EZÂü y³œ6üçáȇŒ¿…qv®rlþÂNcNÕ¨´ÏÝÐMȘÈXؤN¶¢¬BÁâw¸Úçnhˆi0ŸxES3ÑÝ,BÁâ³î;Û ÑŽoŸöäþEwCCL£¥—Æîñëΰøz¿ÃÝÐ>wC7!˜XÃøùD±±=‹Ïº‚ÝhuoÎ%³Zø'/â~ÂëœòøÑ£Öh6{7ugMéQiŸ»¡ab§+7Ç/w÷˜¦Pt¥5H¨'<ê"ô,>ën(¾qغMµPOî™ÂÃÑ]‰\÷“ù¼ˆ ÎñþRKõ‹¼ÏݰŽKCµ«”¶V&¸Eè!XüwÃûÜ Û0ÎPR ·Ø„G]„‚Å‰îæš±pŠBQÓzÔ€!æ,èºIò¨5º1Šd¬Q RÍaqŸ»á!¦iñ³"Ùa¾trK¼=‹ßánxŸ»á?Äݼ  *eVݼ‡‚ÅgÝMud^" HÏÞ/^&QÉQÎiÃ/ãªfŽ Œ‘ 5×/îs7|2Q{â› ¾=‹ßánxŸ»‘›áHrŒjª”ÉÍUèX”‰î&Jj‹ªR6/ÂÀÐ|GŠ„ý™ëg ©) >RÚpÙçndGm¥©ÏÜ¡g`Q¾ÃÝÈ>w#CL#-Š©V¢›õ‹‹ÐC°ø¬»EÑj±"Å[V ¿áÒøg›Orÿ"zM\øö.˜HNaqŸ»‘?‹¿Å!žµ¨;gX|=‹ßándŸ»‘?„ŒŠ ©Y|ß&§øz'~7Í{$·¨áG͋یTD¢)OÆk~± Û7l>HaqŸ»‘a@,­B= )Ƥ_\„‚Åïp7²ÏÝÈ d`?,,-ŠÏÙ)¾‡‚ʼnßaubßä™Ñü;/F£ÙDL•²º› !+ŠòÖs5ê>w#7!£ªh¼1 øçS|=‹ßándŸ»‘[L=JsöÖÚÌ)ez'ºn‘™öŠ¥¤îúÆ&›½d÷Li<Óð£ÓÈ),îs7â£d¡È¾®^zŸÜi,BÁâw¸Ùçnt BVFáâ4›™Z„žE}ÖÝDÓné9著‡käLpXÍæÅ(år±øe°¨ûÜbu®µ y™©Š¡g`Q¿ÃÝè>w£Ll¢Xa÷jSgÍEè!X|ÖÝp½ì\{4IžæQãáæQÔÁÁ0ÇÝ”¢K-ÕI[m$×ÌÔälNqŸ»Ñ›áH¦(bq뤺Y„‚Åïp7ºÏÝèMÈàºI¸*´bUñ"ô,Nt7nW=Ö,ò@ZwãÅ ö¾¹¼ˆ‹ï{5©tí%ÞÇâ>w£cñ7[gÁéÌaz¿ÃÝè>w£6ކ%Ç9`rŠï¡‡`ñYw#X ®`3¥e¬¿é~Xœ"·un™÷âQ£€ˆÆ¬5ì ïžÂâ>w£7!ãĽ*h5ÓYúz¿ÃÝè>w£7!YÎÔj´š*³S|=‹ÏºiÖ£s.ñÏ„¼›î‡½zoÂE2ÂräEèæ"/†ÎûÅÉö)îs7:¡â7ÄÞÖR¸Îª›÷ÐC°øîF÷¹+c(±´©i÷™?ê"ô ,Ú³î&ÞQ%bOY:/*¼9Lz§Z-©ëù¸Ãc½Ör¹{lcÑö¹» ™¦P4D†QßäßCÏÀ¢}‡»±}îÆ!ƒÅíÔÅÙfá‹ÐC°ø¬»±J®E©ü°™™¼h•Kç®Ñ-zf1Îu§AQ jdÖHÊTS5ªís76–GYµ…´û¤_\„‚Åïp7¶ÏÝØMÈDaÍkÅ(¤F]„‚ÅgÝujB^±*ª§jÔŸ‡{k¨na“š¼Ó°kQœcGdæ÷¹»Å4EK·bÑÛÎvÛ,BÁâw¸Ûçnl2Å[WòҴ̪›÷ÐC°ø¬»iõòªé…»KVwCÁVÈŠ—4wƒä V[©9,îs7v2 .¦ÅùÃ~nrŠï¡‡`ñ;Üís76Ll(ާTøêò¤ë_„‚ÅgÝMÔˆèö°@±q¶_ÄEG¬4Õd^¼öܺ¢¦¿2ò>÷¹óñšÄ< Kië=Ÿâ{è!XüwcûÜM‹¿{tX†1¿çS\„žÅö¬»‰lèæý’´gléçañbUØ=¹ÛFx,­Še°Øö¹›v2T9ªÏè…gΚ‹Ð3°Ø¾ÃÝ´}î¦ý!d 3wqŸ:N/BÁâ³îC=jÔ*â”Óˆ‡…J1#)sUäEsl;ÀÍd½€¼Å}î¦ B3PÆÊ}63µ=‹ßánÚ>wÓ!ãZ\°¤0*²É)¾‡‚ÅgÝÇ÷Ž!éEÓsý ª1aà¢%„å—. !kCú¹HØ},îs7í!ÃÀayR£.BÁâw¸›¶ÏÝ´±<ªF÷§—‡eöF}=‹Ïºw ÏF*/R,Û/ÆÃ(¼9ôlÉûÅE„äw%j‰÷¹›6Ll÷‘º¹¢ÉÆ"ô,~‡»iûÜM» ¼üË%,±:ˋ`ñQwÃpŽºlyaâŸÔÝàaéà`Í*'ï=>&ŇՑ\S÷‹mŸ»iÃĦ£líì–xz¿ÃÝ´}î¦ß„L½v¿t|çfJÆEèX캮 (`ÇLôŒ)ÿŸ‡/U9$tšÔÀuï¥rµ!ýe:¾Å¾ÏÝô1EQŠW‹wÓ‡qï]„°›~¶—xzu7\ëžÔ½PɬТŸ‡£¾$‰úÜc²_„hWÌád-u§Ñ÷¹›>LlØ Vá:öòMNñ=ô,~‡»éûÜM‹¿A0˜ÒÌý}zu7 ?‰+¶.%ÇÝüwÓÇò(wì\eФ:«nÞCÁâw¸›¾ÏÝô›©NžbØ\3ˋ`ñQwÃJ(‘ ¸kÍÍÿ<,§­rr–¸5co½*U¢žš_ìûÜM¿ È/‡Ó£œœâ{è!XüwÓ÷¹›~2_”ø¶š\kÍžOñ=ô,>ên˜º¨k«ö0¹OÆ; ÚÉî·¨OIUèés÷‹}Ÿ»é7!ƒ©h‰±6„gyñ=ô,~‡»éûÜß„L㪥´NhŒžOqzýQwÄe‘ðÆjžÔ]ÿÏÃ\‹W«N-«»‰tJànŠwï)îÆ÷¹¿ ±y7.µû‹‹Ð3°èßán|Ÿ»ñAÈ`&Ñ+‘úìßCÁâ£î†±CƒK-²cö~ñzØEk…Â;Ù/ÂÁ¢9¶u :…Å}îÆùn¸7X.@o7QO-BÁâw¸ßçnü&dÛ”0Ýü ‹ï¡‡`ñQwef”§BZ©Yº_Œ‡á9.¸—ÐÔž©ø¸0Eݦ‘G…\RXÜçnü&dé7ªNkQNNñ=ô,~‡»ñ}îÆ‡˜¦+ú¿†Å8³7ê{è!X|ÔÝ0—®aìf­d^Œ‡ Vl×Êzl`%1ìÙ˜¯~ѶOqŸ»ñ›\Æ;2ºb™añ=ô,~‡»ñ}îÆoBӮމÙ"3õÔ"ô,>ën¢³í‘h"¯Åû#©G½†¸›¤KM\NþÌ–æ^ ¦Œ) œïs7>LlмZíÑÌO<¡‡`ñ;Üos7V†q4DR‰@Ì<çÅUèX´ÿþ,ï~Ñ  u%²šÍ‹x •”qN‘E±È¹^þܞцߟ÷Þ)ÖAŽ–@VüŒ¤LNñ=ô,Æ/ù,ÞŸ÷Þ)Ò0”ŠLW«·È3,¾‡‚ÅgÝ µÖ ã¹}_ÊÃ<¬‘DX{KÎL Ö½Q$åøÊG£Ââ6w¹÷>ŽþT —ú\ݬBÁâg¸›ûóÞ;Å1¥T:×ÊQNͰøzŸu7,QeârëÒý¢\Û¢ˆŠ.¹gJáP0¶[šqFwÞ{§ø‡‘Š=èQŽóóÍÔ*ô,~†»¹?ï½S´aœUK-|m¶Ÿœâ{è!X|ÖÝHqcˆMÌ£éKæE<ùfrÌIOFxp~3þ&’º_¼?ï½S„ —Åtuè'§øz?ÃÝÜŸ÷Þ)âB†îØùÜõ¯BÁâLw£Ô½ÅÄ5#)¥ñ°GÐ*™%ûÅ(PµÆ­5SÉÌLÝŸ÷Þ)Þ&6wF+¯âUè!Xü wsÞ[§Xÿ2CðxG¶É,ñ*ô ,ÖgÝ C)dÜÃ(;«GUüé¹(D©ÉYb3Ã:Žø ;µT^¬ûÜM½ ™èJK‰jÓ ¡g`±~‡»©ûÜMý³<ŠIÓî}²qz'º‡6Û:Ö*Õ„•‡1teÕ´%g‰Í ·È®Þ3žŒ÷ç½wŠ¡¸t¯ÝQPONñ=ô,~‡»©ûÜM½ ȦÅ@èDU¼ =‹Ïº›Ê]{”š›Î²sýxVŠdÌU¯¼ØÐ&šD%hIî¦îs7õ^U#s#Óxo̰øz¿ÃÝÔ}A(¼#ÕpÆerŠï¡‡`ñYwi-ŠëZ"5¥l2h< o_ÂRޤ6¼Y4×ï/ŽÆ15×Þ{§x2Ñcr¼5"åѬë_„‚Åïp7uŸ»©CL#Þ>ª1›Ýi,BÁâ³î¦’a*_4òbZЇ¥w¸edwÛÒÆµàþ€SÚðûóÞ;Å[L@w31ìQžœâ{è!XüwS÷¹*Cئì„Ûßh žOqzéYws 5‘&ÜkvNãš%doîU²»mš³rT§ ¶¤jTÚçn¨Þ×ME)?–,Lf‰W¡g`‘¾ÃÝÐ>wC4Ú‡B˜ 긟œâ{è!X|ÖÝ,WƬ\<\ºa\3Úäd^¤ÎRŒWjNãþ¼÷Nq2¥´Æ=ú,x>Å÷ÐC°øî†ö¹&6 {ûxGšÎ”Œ‹ÐC°ø¼g*’œ»Q(RËî™ÂÃR:ä3Õ²y±[­°+‡>¼e´á÷ç½wŠÿ„ª0Í„GúD·=‹ßánhŸ»¡› 8k7lʘô‹‹ÐC°ø¼gÊnê* ‘vÒîzXÈØMÎiDQ¬Ñ¥2{--å±qÞ{§x2ñÔvLc×ãó)¾‡‚Åïp7´ÏÝP²ý­7ÖN|àV¡‡`ñyÏ”3Ç‹ƒ(êj-é¼ÈЋy‹:³æün °m5öâH`9×/îs74¡âp,’¸)Ñ„ _„‚Åïp7´ÏÝðMÈ[ÃNz¸“¼¸=‹ü¨» J M=ÑýpkŽž/þìÙûEçbø¼ ‰Ôœïs7<–G•Hþ•;°“Nczù;Ü ïs7|2Ö•#Ï™U›l(Z…‚Åç=SÑÚFY!7 Le÷‚Ý FüêIOƨ,—ÖèkªFå}‰Mtb3*3ÝÍ"ô,~‡»á}‰Müvñ•J“½Ä«ÐC°ø¼g**1¡K 7·d^Œ‡£È$j­xOí™ú×?G`ÃFTØç°¸ÏÝð0 ®àzá‘ΗÛUè!XüwÃûÜ ÛM«i¯â„ñŸÜL-BÁâóž)Ó(©=Z6ÎŒ Þy;ÂÉw#·˜†1/çÔŒf{¦V¡‡`ñ;Üìs7r2ÜM£ŽŠÊ3¾±“S|=‹Ïº¬]«¤¥b c6/ÆÃp Œ´XJöNƒ/{nð¨NÄ©Uö¹Ñ1 \K4]e¶ez¿ÃÝÈ>w#·˜¦¡~«Š÷÷ÌnzŸu7Œ€½o•`FË‹ “cŽäõ¦&½§D£ë"Ú kªRXÜçnäÏâoÜSQ«ÓNã=ô,~‡»‘}îFúJÔŽ­dXÛ9aá‡`ñYwÃEJ–x‰xf= ý<Œ¹”@ÖJIßð¨ôá•ÕT2ûïÏ{ïÇâïf>ÁßCÁâw¸Ùçnt2RÈØ±Ðž'§¸=‹ú¬»a¬Ša­æÜ{ÊcãçáMUóè73FÇ—Ž`î$f¨é%•uŸ»Ñ:„‹\ŠlCžœâ{èXÔïp7ºÏÝèMÈDåF— ¨Ó¬_\„‚ÅgÝ ‰/]`ªxü+™ãa"%îJ”¸ºf¦°`ŠÑ«VŒ`§°¸ÏÝè dâ·¤ÎW©ÉÆ"ô,~‡»Ñ}îFÇ |µ£p©¶MNñ=ô,>ën*9¬¥õÈè©»þŸ‡£ \xî~1>®Ù'u,tq7“/ÆÃ)îs7:Ä4ñ¶q¾Q¶Lîú¡‡`ñ;Üîs7úÇ€”=®³}6K¼=‹ÏºŒ.š;vÔª’y1.^¶T%õ¨ÿú'"á6¥²teOaqŸ»Ña@\^Wýél~qz¿ÃÝè>w£7!#EÌ£«)ßœÉ)¾‡‚ÅgÝ ²LÇ6SÈg²º”‹°e¬ñýÍ홊‹U®ã-¾f¦ö±¸ÏÝèXü]QH¼$£³œâ{è!Xüw£ûÜ݃PË›päÙ).BÏÀ¢=ênªƒDÕ(«¹ÿl^KäE<\Í ì¥¤æúãaiJ0òõ“·±hûÜ ›¨UŠh´Äj“uzí;Üís7v2ÕŠZu˜•M¸›Eè!X|ÔÝÀUÑqïŠ;ûœ‡ÿÏÃØVX.éLÒÿ*Gù ئÊ{ ‹ûÜÝ„Lü$Œui$ñ™Ü"ô,~‡»±}îÆÆ T9n%‚"crŠï¡‡`ñQwS]¢¿DÞ4*Î$ЇK‰tJê”òÏ.TE)‘b=Õ/Ú>wc7!cb*+ôvϧøz¿ÃÝØ>wc7!ã‡E¦ªÓ­(‹ÐC°ø¨»©KÂ#¡ ® “ý"Ž”ŠÝ6¥f\y7ê± *~zMaqŸ»±a@ŒÎš½™;Ã"ô,~‡»±}îÆúg3óÞ[/MÊäßCÁâ£î¿´ VˆKö~3u‚Z%9K\J%‹ô#×åä>÷¹b,ßÅ+‡fÕÍ{è!XüwcûÜM&6*zôóϧ¸=‹íQwS/ýl‰z,ÒyFÆF÷à 7ƒªD”ôd„µ3f“¢Äí…Ry±ís7m,Â2+ÂòUŸõ‹‹Ð3°Ø¾ÃÝ´}î¦ÑýšÔo~×®³êfzu7FYÑÅoí5'úyX=Þ@0 J{OUh ªÀí´ÐEÂîcqŸ»iƒ)ÑÈÇï©ÖirK¼=‹ßánÚ>wÓ!ТZnD³7ê{è!X|ÔÝD×Öá—åôKr~c¢P€Ñ“ó‹?¼½`ËZÌSæ^«s|Û&§¸=‹ýYw¯¨QÕãKIßp<|í}µŠ‹‰d^DNÁô5#g°Ø÷¹›>Llšüæ<ÒÞ„G]„žÅþî¦ïs7† £€ð‹z…eÒi,BÁâ³î&à$\ùޞ̋ð÷a>¹z¾_ÄX1”©9,îs7},êÚ` Ö¢‘˜½QßCÁâw¸›¾ÏÝô›ÑÒT`’ÑäNczŸu7\jQ#WŠ×Hö~‘± 8âên°‹§W*Ý8~ý%ƒòû£Iìñê1ªE´-ËÌ¿u7}¦S :Ç£ú>wãCLc0Ö©êQ²L¼§¡‡`ñ;Üos7­Ü„LC7ÏÞHz}ænV¡G`±ý÷g‰¼ØÑèU,77êºÌN¿ób< ö ÿ(5“y±°`jäŸèÐ2wý÷ç½wŠu,ÞMº{·gîfzã—ü ïÏ{ïo†­’Fa:QO­BÁâ£î¦adÖp­€UjK7¶ß§ö4êÑ™±%€|Í/b/qƒì¦ãï’Ââ6wÓÊ-¦‘¨Å£héê­=ßL­BÁâg¸›ûóÞ;Å1¥°H2Ì%–çNczu7Xi{ÞjñŸJªFÅÃì‘;„lÍ@þ™_,Õ#!Û¥8Ëaq›»ie2#¬B®ÓS|=‹ŸánîÏ{‚y­¼Ô¨ï¡‡`ñQwc^:ÌŠAãÓºRü}аcľÉŦ­m2þÊ‹M;XXL@Æë …Åm›qÜ„Æù”ø}ŸûÅUè!Xü wsÞ{§8–G5ìŒàøkåÙ)¾‡‚ÅGÝM¤Ãj½Öëý±ž®ÿ­Qç­¢Zo´{ú+/âFK®ØˆS>p÷ç½wŠ7!]|¼'¹µNÝÍ*ô,~†»¹?ï­S¬7!Õ›r‡dØëä¡g`±>ênŒ"—㚣òËÕ¨x8’"öLÅ—VëNåEâB„-yL=‡ÅºÏÝÔ?ÄB„g'³Ä«Ð3°X¿ÃÝÔ}î¦Þ„Låøžá:: ²ç;Uè!X|ÔÝUÅ*'xù'ÊLúy·„bñ¼©æòb<½bBPâ‡[bÏÔýyïâ0±¹¬׿<{£¾‡‚Åïp7uŸ»©cñ·ŠZ”ž­ÍÜV¡‡`ñQwc5^Z+©Üëi2y3Ññ± òc./F}+ïF¡ê‘SXÜçnêMÈÄk²1V™×N³S|=‹ßánê>wS‡‰;GS%×äûäßCÁâ£îFÑ5l§Oö‹×K‡`”þ8u×ÿ¯À•x˜4ÊaqŸ»©Ã€˜®ß¨Yú³ªxz¿ÃÝÔ}åQ˜ÂMµ>{£¾‡‚ÅGÝb8À ä3×ôó0;¶bhÇ,|²_Ä> ‚±³G¢ËaqŸ»©~7¥D¯ÅJV7`ñ;ÜMÝçnh—Þ Å0è=žOqzéQwhŠ©¾‰×®3åE‰:3’‡lOˆY¯Õ`‰6•E®ÛÙ=EÚçnh,þ†Kyë77“~qzé;Ü ís7t2]jÁ¦Œæ½Lt7‹ÐC°ø¨»Ñ¿q'(ÚÅkªF½¶ËÆÛ Çß ©³ÀÁJbªÖ2;ÂïÏ{ïy¾+l£Ÿí|[…‚Åïp7´ÏÝÜ´ZSŘpBnr׿=‹º›€“à¶¿T¡ %Ú_y1þ®XÁ½fKÞõK ß¸Aƒò8…Å}î†Æò¨&½›g“)ÔUè!XüwCûÜ åQRµ]o.“;Eè!X|Ô݈šµ(Q ‹³y1†·ª4/Qª&ï4‡—c¦!âmÂâ>wCÃÄ&þˆ^ãÏ(ÑŸNNñ=ô,~‡»¡}î†!ƒ/[w윞â{è!X|ÔÝHtkÑ(vÅØ%®ëéça*7ÔZ"™$ûE,€ì†ÝøR¥ïcqŸ»!ư[€%«OœRV¡‡`ñ;Ü ís7ên°ñS9ŠÄB ž’y­UdSWÂèU./Âá8²ýf)œÊ‹¼ÏÝð0 &3+Ñk“ÉÌÔ"ô,~‡»á}î†o1M©˜Î‹V›T'§øzu7 BÅÓ¼”{ºyÔÈ­G±É¥¦t7ÿú§Em[Üjäåâ9Ý ïs7|2‰;~ÉK/<é4¡‡`ñ;Ü ïs7<Ä4(¥à€MÔäßCÁâ³î†ìZþIÜ$Ù/ÆÃGUê˜ÙLæEs¯5Ò©YïÉ»~Þçnx2ØÄ¥gušx¯BÁâw¸Þçnx BáÊ—Iãý_fÕÍ{è!X|ÖÝ´ø¥ƒB˜øJö‹ñ°X¨¸%g‰­šD!hX´\¿¸ÏÝð dÌã_,~ÝÙ)¾‡‚Åïp7¼ÏÝÈ dªˆEýÙ*Ü­OqzåQwc‘’ªAùR˜326úy޾«S]Û ÿu¿¨½”·kÊSý¢ìs72¡âÏèR‰À¤ë_„žEùw#ûÜÜ„ŒDû€²%¾m3ÝÍ"ô,>ênL±5¢Grª”_Ô(¬ ©pZ~ù;ÕëýX˜R÷‹²ÏÝÁw'L¢`‡ûìúz¿ÃÝÈ>w#CLÓÅI°î„f5ê"ô,>ên¬GqZKew§õV‹¿òbwí¸P­‘D8y¿X£­Žo½âj½¥°¸Ï݈Þ%‹ L²µ>ñð_…‚Åïp7²ÏÝÈMÈÔîTÍ¥Aç59Å÷ÐC°ø¨»iªfp-°dK¤6úy¹#º=‹™ÔÝÀÖü8"))îFö¹‹¿íÚ7èÓ™œâ{è!Xüw#ûÜŒÅßÚµ[!þã„G]„‚ÅGÝ 8ßR¬_®I8Á> ñfgÚ{JT+G› £ žÂâ>w#ƒõ£ ûÌïfz¿ÃÝÈ>w£7!£Ýjíño>}£.BÏÀ¢>ênâõápÙˆ¦/ªëÔÆõp£n—­bÏq7ðð—Þj¼¢šÐ’¢îs7:Ä4Ö±×®¡ðœp7‹Ð3°¨ßántŸ»ÑabSª–øšÆ7`6׿=‹ºˆIÕ®ê½SªFÅÃæVŠâ^•sû4Ê?XÃ]«\cš»_Ô}îF‡1—®M`—™bcz¿ÃÝè>w£cñ·aܶƒò¯3,¾‡‚ÅGÝM§ëÁ¢ñ‹—¯‡Áû«]£ ɼx-á.9±zÍylè>w£cªÃ –1M>ãQ¡‡`ñ;Üîs7:WÆ7î~0ϧøzu7гÜrk‘“y‘… –ŠZšåf‰Ë?¬qCô¥jê~Q÷¹biTØa9óð_„‚Åïp7ºÏÝèÓ°5,†Ƥë_„‚ÅGÝMo‘£×Ó¨{fì‰~ޝmÁ¼fqMênXärw0Rüì÷¹½ ™xe`&Q c2ìùßCÁâw¸Ýçnl˜Ø4éLX7!3ÔEèX´GÝMW….¼Âc£ôäþÅèó`"Š¥ÝPÐ$ó"cõ/i‹ W<¥³}îÆ!SºsuÿeæÎ°=‹öîÆö¹û³<ªÀLóë“íÒ«ÐC°ø¨»é˜öÈä╳{¦¢wøÇU¬³äœ†P7–¨‹Í LOaqŸ»±?Ë£Z¼0†5gû4¡‡`ñ;Üís76–Gq/Ú 1blrŠï¡‡`ñQwÓI´¸°ª)~úy˜Ä¼Õ(ë–¹¼¨ {n¨\´bE^‹ûÜA(«ûŒHä³[âEè!XüwcûÜÝ„ C»L2'{‰W¡‡`ñQwƒ+¾Rqß®øK6/ÖJÅ(êÛê9,BXî䂵ݯMûXÜçnl÷¨:¹°ÃwnrŠï¡‡`ñ;Üís7v2Qr:–h;!&§øzu7Q›Ìrä7¼@ryQz¢×¾¨’ìMëŒ{oñ¨©; ÛçnìÏò¨øç¥}e™u`ñ;Üís7m B5¨hj‰¶jvŠ‹Ð3°Øu7Ñãòu+ª"%W£^GŸH(q£ïKî|3,{‹VÑØ!‰Í`±ís7턊J?ÜäóìßCÏÀbûwÓö¹›v2Å1V*X³ “‰ðEè!X|ÖÝtì ¬xv/qïÖàÑ¿âìnÕÈŠÜkôÙ¥§jÔ¶ÏÝ´?ƒPX1ç˜òöIu³=‹ßánÚ>wÓ~‡‰\6…ËäßCÁâ³î¦qü¾°Yf/Y=jÇ’pª Óšôηèú07ƒ›‹§jÔ¶ÏÝ´?&6Ú±Ô.þ”:¹ë_„‚Åïp7mŸ»iƒQj-:@»|ÒžOñ=ô,>ën:œôÙœa•Õ£vxÈÕV­áb"™ÈÍj1íN9ÝMÛçnÚâ®Míò“š°á‹ÐC°øî¦ís7­ß#4‚4z)ª3õÔ"ô,>ên°ž.z£øÅ½GJÏåÅx˜(*¹"EZ&©^yÑ­×Ȭ]¢"äÔ]ÛçnÚ½< ¸‡6¨Ô©Ü"ô,~‡»iûÜM¿ qêM+ÆK'oÔEèXìº7 $E*Ç0{Oö‹nñ‘ŠYFX~ù£2¹aV£X¤Å”ÇFßçnú-¦‰¦(s\ßLúÅEèXìßánú>wÓénÙıAÆî“S|=‹º\GX‹¿`§©%÷iÄÃ[Å^:5Mî™ÂÒ‚ªôšÒÝô}î¦ß„L+½6¬›í¶Y„‚Åïp7}Ÿ»éÃĦPí9ƤºY„‚ÅGÝ T/ñ 9¥Z¾+/Џb3ZG"IÎ/¯\ܬr‰7A./îs7ý&d:׆}ÃÔÊ´ºy=‹ßánú>wÓ‡16•ß9§‰bczu7® K×ëúšód¼†{/GѬoxáÖ0JlT$§GíûÜMbšèã3H5›Õ¨ï¡‡`ñ;ÜMßçnzÆñŠTí®uƆ/BÁâ£îÆ#!:‹0+cdó"²G÷‚´šõ ï•ÃÒ"¹±ïs7ýÓtS£GÕ©³ûÅEè!XüwÓ÷¹&6Â_X,]OqzýQwãB®$‘Öà%™åQ™ŒF‘š1¿ò"S…ê¦÷µnêNÃ÷¹ÄQ°´ë/6ód\„žEÿwãûÜ⪢Åq%=»ÓX„‚ÅGÝM”ˆn½[¼Eâ÷Îö‹lv­š‚eOò¨‘QÁý¦­Šç°¸ÏÝøXü­`s\l'§øz¿ÃÝø>wãcªÂãÌ#iØl/ñ"ô,>ênœ;I5Ò[IY¹ÑÏÃX bU„4=§aÌñŧN‹dRXÜçn\ÇP"35ìɘâ{è!XüwãûÜBF!€Ï}±Ùõ=ô,>ên·iXSW£Ú̬§¹òb!ëðŽ*‘á2îµOãºÒ¬Þ šÎ”Î÷¹„L¼9:ÁèmËDɸ=‹ßán|Ÿ»ñ›¡¨¿ŠôxuëôúzŸu7ðœÑ@SÖ5c7üs¿ØzüIÁÀZjÈãòG•ZžÀ‚Ûƒ÷¹÷!l“&yœX&7S‹ÐC°øîÆ·¹›háoC)ëñ¢¼Tûþ|K¼ =‹ý¿?Ë+/6,–‰J³3§l2~t7î D¬¿QÒÃ_£+«P`Kk×]¿lžâýyïâ-¦ñ ÃTŠ>ÏL­BÀbü’_Áâýyïâ d<¾p ›´VŸkÔUè!X|ÔÝÔrõcÉ”ökÔbr¶O§X Es,ñçõ¨rûþ×Wq7‚UNÏÊ43¿xÞ{§8Ll¬Ã\KÕÊÄÃz?ÃÝÜŸ÷Þ)B¦W‹æ! ©çuzu7|WmQjúÅfncñz¸Gbä8n”2ò¢6ÖxDNµø2<êýyïâ d(úáb¸¾·ç~qz?ÃÝÜŸ÷Þ)ŽA¨fñ†Œ¯LT Ïw«ÐC°ø¨»©•#´c×zÝõgòbên"1Y (6Ù)•][óŠ›8ñ$ŠŸÌa$ÆÒryqŸ»©?„Œ¡¶(…­šÎNñ=ô,~‡»©ûÜMË£°ƒ‰12[&^Å«ÐC°ø¨»Áf,è f‚³yÑ <©Ç?8…Eì78{´Æ—Óq ‹ûÜM½ ™(…‰0áå4™|[…‚Åïp7uŸ»©7!Ó$ÊN*Øe=͋`ñQwS¥»+Aä=QfÒý°6èY½pËæEôšZÔ`([syqŸ»©cªSâŠe“S|=‹ßánê>wC7!ÓXÍI[tô×¢UèX¤GÝMµHl¥QüâELæE#íÎÖšZ¼æ’y©>—çMª_¤}˜&ßâEéÖ/.BÏÀ"}‡»¡}î†èOá݃ìazvgX…‚Ågݹ 6b˜0™±"¼âRµ–®é~ÊÏ*Kàµ)À¯SÜçnh˜ØÄ놺EW;eá‡`ñ;Ü ís7tG-U) –Èy4áQ¡‡`ñYwc°X‚¦©Õœè~XTAv`7N2/‹„ŠW@džò÷¹ºÅ4WþG7_úd+Ê*ô,~‡»¡}î†Æ TÔQ°÷ZÚìßCÁâ³îưh°`¥9eûE¬1e SÑ’ÒÀ•¬Ûå„ N©©»~Úçn¨Ý²ýê~Íz³Îîú¡‡`ñ;Ü ís7tBÅÉS‹ïK|é&³Ä«ÐC°ø¬»iEãÿ=êD¦d^Œ‡!ø+Ø öš™‚ÕˆaX«§öiÜŸ÷Þ)Þ„ŒU–¨>ãhÚŒ _„‚Åïp7´ÏÝðŸA(/Z l’f]ÿ"ô ,ò³î¦‘—b0®o–Ì‹º¨*wòÄÃ?wýZ›Pýÿ×ÝÛõÚ’äØaïó+êÑ~¨‹~EP€lK2`–Kðã 5SÂ4ÐÓ=˜Iß\¹3OÕ½‘#U]ÝÍÜgŸd®$¹‚\äª%ÕÎëÜ Ÿ„ ´kº©˜Ù‹Ó=°Èïánx»á“Á¶ 7‰çnàÅgÓM°xßwÓTY9~ S¯Ù¾›¦ØŸñCk„¸\ŽªêÄ5#ÛÙ@·ŽÅuˆ«tºAdàÅgÓM°øî†×¹>›iZ<-Z…íQ/>›n‚Åû¾›¦HÇj¡TŽú¹ÛŒ sˆ%ä£7<.Œÿ€sF;\ ‹ëÜ Ÿ„Lñ¯›ˆxTG}7ÓM°øî†×¹¾ši 3zñ¸õQŽúlº ïûnâí¯Œ­^[†~¡óâ¢ù€Cy›n‚Å÷p7¼ÎÝðIÈÔæ˜g3í`î½ølº ïûnLZdšTDJ6.Ú¡Uã­WýH§ÎúS=2Õá'‰Åufš%‘V"ùuOML7Áâ{¸^çnä$dœà•(ç3E·^œ˜îEôÝ(Y`Á½×@d6.B öÐØˆ—OòL#ÒˆR ˜c¼²mî÷^”uîFNBFÑÅnÔ‹f‰'¦{`QÞÃÝÈ:w#¿2îXÇ Õà:1Ý‹÷}70ë…5ÝŸ²}7q1CP´vB%Ï4âÇ‘t.-rOõ£Ê:w#ç ”h›S¤Ÿ:ªú'¦›`ñ=ܬs7r2Å£ôÈã"‹½QŸM7Áâ}ßMo…B¥*Jiü|L‰X›HQM²ÚSZ±¥*¢jmS•äXÎ݈ž®ÁÚ!ìP†ÞâÀ‹Ï¦›`ñ=ܬs7r2ñ¤ªlö¡ŸM7Áâ}ßͱ>‘›uÒ– mt^lœ#—Ô\ÄE¬åòøÉ‚5Õ.ëÜ\ƒPÅ ‚©ùML7Áâ{¸Yçn¤ ëcXñøßF^|6Ý‹÷}7Q'[‰=Фd\tA\íªI ÆŽs´ˆG®:U,ÿ΋ëÜœ„Œ“Õxs`ryàÅgÓM°øîFÖ¹½–GäS~>¨4&¦{`QïûnâÃfs 0Ʋq‘ ‹ÇÓÛ2Wˆ‹\±!\©{Ñ&©zQ×¹½–GõfŽé,i£®â‰éXÔ÷p7ºÎÝèIÈ0k#ìŒéÀML7Áâ}ß[ Š­o.),~.&CËŸb]U2.r#šLk-­¤â¢®s7z6Óh„ýÀ}©ª6˜B˜n‚Å÷p7ºÎÝè%bÃ-Ü¢Zú “qbº ïûnzd|èð¬ØÙÕG‹‹ †ž{ò|1^\S-P.”ÒØÐuîF¯ÅߨgÎí9ÅÅgÓM°øîF×¹ý±)DèÆ€ ¸›‰é&X¼ï»AK¸Xü¿HËž/v(tÄ;¨I„È$ÊÈN½·nñMã|çÅuîFÛU¢]>}¤U<1Ý‹ïánt»Ñ“a,%ƒ|-Qå¨Ï¦›`ñ¾ï¦u9ÈPŒKärÔãbP aÙ’ý¨(5±œöhioÕù΋ëÜž„Lm,–ƾáŸM7Áâ{¸]çnì"dp .$Ê4ª'¦{`Ñ}7ñ­ÕÍ6Ųó‹h ŽëÄ o¡äù¢„eï½7©zÑÖ¹»ˆU¾ÁºŠ'¦{`ÑÞÃÝØ:wctµ'–¢Z­T쟙n‚ÅÞM8%ž˜n‚ÅÞyÉ]üó£Œ˜Š‹Ö6»º¤µ§Ô J‚ ܵ×¹; ¬Ð±¢mŸ:1Ý‹ïánl»±K€X  !.ÃìæÙt,Þ÷ÝkE‹³qJ{길€¿q‚Øiª7¼ËkÄUœ¨Ôd½¸ÎÝØIȰ`ª+¾­÷Ñþʼné&X|wcëÜM; lCŠ'G‡ÜÍÄt,¶û¾ʨ¯‘`ö|Ñ”‹G’YÉ?k¾3»P#øXEƒÖ¦ö·uî¦]ƒPqf%¡”5PJ™˜îÅös7í„Â[²b1ÙP)ebº ïûn‹ÈÉâ‹·È®Óó‹|œOªEKÎõ“Eìñ>"ò:×¹›v2P.(¯Ê>ÊQ'¦›`ñ=ÜM[çnÚIÈ OX É8»÷â³é&X¼ï»1³9jñ5Ét½(ŽŠµ'Ïú[¤Æ(®ã¦y?N6eÙ‹ëÜM»[ÕxmDUk£Jcbº ßÃÝ´uî¦]„Œ¶È¿âXË7ðâ³é&XèÝà8TO‡|wzŸk9hJ|D.GE_8šèX£º.©ám»i§1g¡Xm×Ú ^œ˜n‚Å÷p7m»iW32™5sª£3‰é&XèÝ4kŽf´bšÞ3eXj£èœqõ¤Æz`ã"똞)¹zq»i'!£DèM$ak£¸ølº ßÃÝ´u„Läp„‘D‡ ¼81Ý‹}ÐwSŽb ß:¯W,¢›!õœÞM\ q†K”ZN{ª¯s7ýZEÊX”nmðF˜îÅþs7ý$d T@#“êxñÙt,únØU®bOº^ä^õh¾‰ß<Ù‡ÃtÌ—¢ØT•Ââ:wÓ¯A(落GÁÖ€ŸM7Áâ{¸›¾ÎÝôK€¸qW%KGþÓM°xßw£P+QÐÔØ}.f‡V“°TÍî_Œ€Ø5¢r\Ÿš™êëÜMÿ±¡c]4gÓM°øs7Ý®á¦á“*6˜_œ˜n‚Åû¾›H.Ë1Wb­ö„LÆ#ü÷J8&”ž¹ø8Ó¨‘-’”šëïëÜM?›ibx+蛵ŸM7Áâ{¸›¾ÎÝôKÄF:q;ÑF»m&¦›`ñ¾ïFÐ)Ô5²L{÷'.z­U©œ‹f5±|UºõÆúáQ×±¸ÎÝô‹<–ã À†OL7Áâ{¸›¾ÎÝøIÈ4!har}Ô±11Ý‹~ßwMÄnØLA=»gJA7qgIò¨d8 ÁF æÞSšŒ¾ÎÝøIȘ„@– Î4&¦{`ÑßÃÝø:wã×âoªQ;hqª¿OL7Áâ}ß ¶/Fi*E¥”‹½F‘"ÉoÔ G±lœ-ÕîëÜóÕð :F*äùÜÍÄt,¾‡»ñuîÆOB&2–^¹sÕÙÀ‹Ï¦›`ñ¾ïF#°rÃͲú¨8¦Çc‹zQSsý=nV%抰˜ª}»q½ÖâabŸiPõOL7Áâ{¸_çnü ö(¹G¼Ó‘:ÃÄt,ún ‰ï‘)3iæy¾ˆýR‰9Y2.¢Ó‡¡ÆØÄ\r9ê:wã'!£Í:4 5½QŸM7Áâ{¸_çnüj¦©˜ñ#ì‹£Qvólº }7U„ÝŽ¥¦9îæ¸˜©F²©$³ZÅÈOk‹r“¬§f‰}»q?Ǽ©¢¥!²bn£ªÿÙt,¾‡»ñeîÆËIÈÄ K+ZµÜWý3Ó-°è}/?qQ¤ŽÖpËÏi€²é€SKkø38,·b²F,ž÷{Í‹× TÃ;ÒZ<ƒ3™éXŒ/ù,ž÷{Í‹BÆkd_XÚÕ|½‹3ÓM°xßwƒi„FÕ¼’õÉz‘å³3çãÙÝ6=ÞZEZ9Ìîæ¼ßk^< ™ˆ¼®ã½×ŸM7Áâk¸›ó~¯yQN×D¬Ó©”u^|6Ý‹ƒ¾U²æhÊŒxTô– ys¶”fxÔF8Ôì‹–—¹/g3 ’‚@yDáQvólº _ÃÝœ÷{Í‹'!i¦FÜvcàÅgÓM°8è»9Ùâñ.…kú|1RÌÎÌñ›[Ik2V¬'÷f„½),.s7^NB¦ÇïÉ…#oxñÙt,¾†»9ï÷š/Bƺk÷Š5`÷<êÌt,Þ÷Ýà0¨†Áþ,*]âj¯-ÒÌ\ŽqQ1Ñ_ŽUáV3;ßÎû½æÅ«™¦Dü&á¨]Å3ÓM°øîæ¼ßK^¬!C„½dñۙéX¬÷}7"½3lúÍ꣊ Í¨º5—ì\Ü¥â„ÕÔ-uÖÞï5/^Ë£ÐüÞß/>›îÅús7õ±é5^ß‘N¹·ŸM7Áâ}߯˜±#ÓRú‰‹Ú['V¬/ȰŸ~ÔêM±fŠ"@fÎúÏû½æÅ/ü¸Þ]¨ÝÏ/ÎL7Áâ{¸›ºÎÝÔ³™F­Qq°öˆ›˜n‚Åû¾! FíVNÙzQŽ-¨\èxv“q1.C‚+:9,®s7õl¦‰ÒA1.é‘ Øð‰é&X|wS×¹›z-ò^zÅ%·Qvólº ïûn°hˆeûQ¹÷&š2Œ†&ã"ö3æ’L-µ—ø¼ßk^< “R± kÍGX|6Ý‹ïánê:wSû5|!NÚã™ulÌL7Áâ}ß Ž»5ˆ×I† ¥ÏÅ…‰Œ£fyTftÄŽ«F™™©ó~¯yñ$d°Á\kqóŸM7Áâ{¸›ºÎÝP9)n-‡ú§Ä«ràʼnéX¤û¾A‹Bµ˜¤œ&ãqqÓxj9~óÔ€†-JîÔÊ©¸HëÜ ]ƒPзŠtüÀxñÙt,Ò{¸Zçnè$d$*šþi×ÌLÍL7Áâ}ß`µ(1v¡Æ7ÏÖ‹Ø5xBpÍa1..ñ À¡}'u¦AëÜ „Lü”ÿ¥vÂϺ÷â³é&X|wCëÜ ]Ë£âY!%dS2àQ'¦›`ñ¾ï†ÕGîTÓõ¢Fb‹e…B…“<ª€‰ÿ¿«&4Ïû½æÅK€˜£>acƼäÀ‹Ï¦›`ñ=Ü ­s7ô!d@08a“uá2èžš˜n‚Åû¾VmPËŠ›n‚Åû¾›(ôj±ã¬^{¶ï†JL=YÍÍõ—ãp²3"ÉÍõÝð:w׈)ä@¨²ø G˜n‚Å÷p7¼ÎÝðIÈ5ƒŠ4ClàÅgÓM°xßwPÈ”š ÷lßMLN±ƒ±r±ñóÑ*Žl0ª&[rX\çnøj¦)ÖLZ  öiÌL7Áâ{¸^çnøZÕzÁ¹/éà|qbº ïûnê¡ßmb/Éò¨µ9Ä}½´´öTdƵ=¸q꬟׹nW÷CNªáavólº ßÃÝð:wÃ!ÃM!ÏÔv¢Ý{ñÙt,Þ÷ÝTÃÜ9¤Z¶ïO%j«çv¡3SJDîH/ò:wÃW38rqŒêۋϦ›`ñ=Ü ¯s7RNáŒøSü˜?l´™îE¹ï»©DV0ô¤Â™4ó ²%ÜK¹¹þC«˜›`ï[‡›n‚Åû¾t¿X€ûeÒ{¦³)X‡Ñ ç–Ôd¬@!†¡ç˜Ù…zÞï5/žÍ4‚!M’†óÌQ\|6Ý‹ïánd»‘KÄ•|Å¡a©‰é&XôÝð¡ r,ŽÌí¶ÁÅ„ôR»°:%yTl`­îÜÐcÐsX\çnä$dÂ3$PæW’ŸM7Áâ{¸Yçnôl¦Q>VçH  ¸‰éXÔQßM”kØ÷VŽH2.˜KÇntJö£2ðoM°SG5£áÞï5/ž„ D•­´â_ï½ølºõ=Ü®s7úµ<ÊšSÄí£Jcbº }7-’ÓˆjêMr9*.Æ©$™-⩳þˆ‹‘‚ª4‹ŠÕS<ª®s7z2h~=ð‹xÔ‰é&X|w£ëÜž„ I¼¸YâA…ºõ½ŸM7Áâ}ß 4ÎG%ãפˆ§Ž1±Ì‚ñ#.²’ Ö§°¸ÎÝèµø»`P³@:rĆOL7Áâ{¸]çnô‹!*¥T}GqñÙt,Þ÷ݸPÑjè‰NõKa¯Õ[©Y (¬sáÝÏië:w£—ˆ äù ´DÊhŸÆÄt,¾‡»ÑuîFOB&ÒN#áÏ«Œ¼ølº ïûn$RÔF½50ùÙ9 È0UÅ»'ÇÝD\Œµ[ĸÖ{Mbq»Ñ“1¿`ºU‹&¦›`ñ=Ü®s7v2Ñ@l,r¸71Ý‹vßw@Š÷ûÌgëELXDÅ ùªšY¤zÄEÜ,dÈTØŽ®ôe,Ú:wc_ƒPlÜÂÿQ¢º§&¦{`ÑÞÃÝØ:wc'!cŽÁó"{í^|6Ý‹½è»°hT|³q{˜]Š·ˆ&Ù¸%R¼J«ÅS<ª­s7Æ×€0£?¨·ê£Þð‰é&X|wcëÜ]"6ñ¤aöâ_UÿÄt,öL™ö¨q•òâ³éXlïánÚ:wÓ®åQâëì±Èep¾81Ý‹÷}7= >#ÃFŒÒ²z7d#ˆ4‹´<©wcÐdU¬ v\¼ŽÅuî¦} B•!ÖH0pÓM°øs7íj¦ÑH; C*IUÿÄt,Þ÷Ýx|åêh1[/: ce·ªõÌbþ,Œsrc¬_ô\ox[çnÚ9…-:êz䞣oÓM°øs7ͮijwTU]l¤æ71Ý‹÷}7ÎKj0³—Œ‹Î˜,еQ¥äùb\@Œ¡~m‘¦xÔ¶ÎÝ´kñwãÂPeŽŸ5òâ³é&X|wÓÖ¹›v2R™6§p/>›n‚Åû¾›IM *ñWV7ûÁMå•g˸X*ÚÑq¬n•äu,®s7í 憟Â-jˆ2ðâ³é&X|wÓÖ¹›~2¨¶È>kSô†OL÷Àb¿ï»‰;^ñ½%þÊUjDU“qÑkP·bQ98g´Šû:wÓOBF…5µt`qbºû{¸›¾ÎÝôkyTQqA]5웘n‚Åû¾ìáw( Š’Ù¸h=@(&åìn›Î‡Ôqd·XS^RX\çnúIȘ’IGëkó71Ý‹ïánú:wÓ¿'*ˆyÝFoÔgÓM°xßw·$*FÆ6ÓÏvàT\ì 1ÐÌZ<É£6Žü‡)MK·Ôž©¾ÎÝô“‰ÌB¬ñ*ƒóʼné&X|wÓ×¹›n×ðEǾj<8럘n‚Åû¾€È9P.)·O\iE;I”Xœ¬M#Eeí%žüH SX\çnúIÈ´ª•‰ræ¨Ï¦›`ñ=ÜM_çnúIÈÔª‘«t׌N¦&¦›`ñ¾ïz5jjÝ’©³þãbŲ¸HTY[RÕªbÈŒH[%µÛ¦¯s7ÝOŠÛÌšQ‘ÖFÜÍÄt,¾‡»éëÜ_ƒPïmÁÁ£NƉéXôû¾Ç~ºÖ ¶¤zÃ?Å&¦ý¢ì+jÉzx¥ÔHQI«¥¸_çnü"d¸G&ÞÑÔ0RJ™˜îEwãëÜ_„L‚o Ÿ1x£NL7Áâ}߇|l^0²‘‹„Ùüøˆ•_’GUVF·`¼EëX\çnü$d´sC£ß€›˜n‚Å÷p7¾ÎÝø%@\D0'ìuäÅgÓM°8è»96FzƒhVÉê†{é­Q`)0•¸:v„›Æ‹«ˆkiŸóÅu,®s7~‰Ø˜°Hżå¨{jbº ßÃÝø:wã'!é¦9-5RÏŸM7Áâ ï& £Žs~Šd3]/Ö@¢â¼¾ 'õn¤Jù(åu‹ëÜ_‹¿ÒŠs}„ÅgÓM°øîÆ×¹¿ˆ£pˆ‚JH|¤w31Ý‹÷}7à] è,ôJÎi4«ÇZ­¦–Y0þÑëÜŠQäƒÇ¸u,®s7~6ÓHÅéIa­:Rœž˜n‚Å÷p7¾ÊÝÔøël‰êÒ½Š×Â÷m§¦;`_ò6.vÌ- ¢€SFnø3§á‡â°6Žt55K|ì™’†nÁžÃDŽzÝï5/~2P\0ÆÂáÛìfjºñ%_‚Åë~¯yñ Ž<Ê…µ³Éí)ñÔt,Þ÷Ýtñ®Ä(q)·Ûæ¸ØÔj\]¥gD޹þB‘ Ó1RÜ8‘£^÷{Í‹'!Ó´6‡àBÄ»[6|jº ßÂÝ\÷{Í‹—ˆ u5ªlµxñÙt,Þ÷Ýt9´@ÑX*šŽ‹ 8zŬ…gõnÂMíÕZ&G½î÷š¯åQŽä"Vû½öÔÔt,¾…»¹î÷š¿—Ò½´Îr?×?5Ý‹÷}7‘X÷xö¢>Šß${¾Ø:N&$Ü¢œ:Ó@\,e5.6”×,®r7aú%@Ü"Ú‰r¼wFÙͳé&X| wsÝï5/^"6&Íé(çõvNcjº ïûnâ;G bÏL2.𡱻NE2G\Dÿ\dí¢ËÕ‹«ÜM˜ž„Œb£z ”ï§P§¦›`ñ-ÜÍu¿—¼XÏfš†æ‘¨‰¬¼81Ý‹õ¾ïFÙ! êU3+1ès±¶Z•žåQ#¯Årñ^ÝâË¡R•U/Öu„ â\iXF÷ÝSSÓ=°XßÃÝÔuî¦^ÄQû…_*sTU/>›n‚Åû¾Q AáÔk† ýè†Gèðø­MâïI5°/òdÊÇRãu,®s7õj¦‘(h«j¼%ˋϦ›`ñ=ÜM]çnêIÈ–E„c<€<8Ó˜˜n‚ÅÁž©Èª+&öš–œÆÆq±BF°+*s8yÌ/Áçxòõ¨T×±¸ÎÝÔ‹ÑÚÍ·î£Jcbº ßÃÝÔuî¦^Í4\pâ$ñW¿™ššn‚Åû¾¶ÀRQå(Ý$»Oݤq)Aæ4#ÐqÔ‹%ªE $G`Lô†_÷{Í‹—q$áP­òø^)ejº ßÃÝÔu„ŒV„9jµÞ¨Ï¦›`ñ¾ï†!¶Ô¤7‰¬,k Iâ+¦i8N:EBPî),®s7õ±iÁç¿t?…:5Ý‹ïánê:wC'!Ö0³®~Û75Ý‹tßwÃDZðüaŽ0«Ç8Z,ñ ÒÐ Ÿë»ARáÆ$q} ‹´ÎÝÐ%@,‘ˆ{õÞ#xñÙt,Ò{¸Zçnè$d¼Vê‘EÂôù½ŸM7Áâ}ß YDD¬êŽÈèÙ¾²À’ †Œ´$uÃ#).lGå(Sgý´ÎÝÐIÈ@Í=b7v!Ó€›˜n‚Å÷p7´ÎÝÐIÈ(VEs‹úAG•ÆÄt,Þ÷Ý„§J$Š$šY¡HŸ‹%Ò~´v³f†<Žý‹½ÕHâ-U/Ò:wC'!cäñ;ºwô±¼ølº ßÃÝÐ:wC_Ë£´a\6VõâÄt,Þ÷ÝE¹f‘—‰ôŒ ÿ'.Æ›§ÅßâÏš=_i@Ž\Q(¡wÝï5/^„LÁ&ÜãÍî7½OM7Áâ{¸Zçn象Þ\˜M¬ƒªbº ïûnH!w}Ä@T–G…:†tN#¼%÷L¡éS+HŠ ‹ëÜ „LŠí4üû)Ô©é&X|wCëÜ —ë_Ñéå-^âîfbºù¾ï†ªEr UŠfyTªÄîÍÉóÅHLåXWÙ­%tà®û½æÅ‹)‘O÷…<„\ï½ølºù=Ü ¯s7L×°~+eœ†¼ølº ïûnpºW ZXÒz7‘›Fuå +sXŒz±|5¨·Ö´¥°¸ÎÝð5Õ:sUà ŸA¥11Ý‹ïánx»a9›"a9ĵ¡x6ðâ³é&X¼ï»¡C?*²ÌÀcÍêÝŽôK¤å-3puÄÅ*X©£17•Ââ:wÃ!ÃqEã-Ýï_œšn‚Å÷p7¼ÎÝðÕLÁÔ©ÄÌàLcbº }7 BXû¢(ÝwS¬˜‰@•1}¨c»­æÎúy»áK€˜•°?*jú71Ý‹ïánx»á“¡±Ã»ïõn¦¦›`qÐwc 3 2RœY¡øé»Qíà~ ꘭Ñrç•]ñèçÎ4x»áK€X0yQ4ªSUϦ›`ñ=Ü ¯s7r 7hƒ)#‰éX”û¾ÁW Bܨ¤v¾£©´÷îèsHîÓP·êWîMÆë~¯y±^mÍ™´s¼woÔ‰éX”÷p7²ÎÝÈ5å‘FᱩXqïÅgÓM°xßw#vˆIDõÖ? J&.ƒÄ­‹G8»‘¥©8–#"/î_¼î÷š¯åQî)µšbË佟M7Áâ{¸YçnäZÅ‘†‰ö±cPõOL7Áâ}ßM%µˆ½x긞>GŽ)Z ´“ç‹ñÓ0\ ¬Ç†«u,®s7r j‡&¤ rÔ‰é&X|w#ëÜ\"6ì·Ø£;ðâ³é&X¼ï»‰ïʈåØS“9®ÿÌõc¹ Çs Áôì^â¸M‡°³ “žRX\çnäj¦éR5~UÅ~ºŸM7Áâ{¸Yçn¤Ÿ’ Q i+)ÏŸM7ÁâHï†í:€ Ù½Ä‘ÆEvkèóí᪜Tª½cû¢µÄŽðë~¯yñ$d*ññ¦lʃ~Ô‰é&X|w#ëÜž„ XQ*åXø9ÈQ'¦{`QïûnG&fh§0ÅÝ|f TŒÎ¿O.~t ‘êÙR9ª®s7z2lÌ„÷¤øývé©éXÔ÷p7ºÎÝèµ<Êš·c¦Èm'¦›`ñ¾ï¦Õ£•;õl\l›`*›i~~CÄ­J1Ç+,…ÅuîF¿ši u¡šhÀÝLL7Áâ{¸]çnôZU™âq‰7?Ëà”xbº ïûnšs”¸ØMÜӞúˆ«¶Rµ:«rr®ŸÌj<ìuÔšãnt»Ñ³™ÆkºÑ®ŒØð‰é&X|w£ëÜ^ƒPîØ¡A죹þ‰é&X¼ï»éJŽîKöU_Z7¼¡ƒšÅâÉzS‚&q³(*ö×¹= ¡¨‹²ÈÊ(.>›n‚Å÷p7ºÎÝè%bc]#+Š4ª+gÓM°8Ø3EÕÑ^ŠôLÛgŸÆÁÞDN!„’ºá™`<삌–Œ‹ëÜ^ƒPª$µôcíÀÀ‹Ï¦›`ñ=Ü®s7v‰Ø”Æ8®Àër€Å‰éX´û¾›(øj„DGrX<.0AÄß"B¦¸Ìi`÷bä¸ñ·ÏRãe,Ú:wcW3"úFeLe4ù61Ý‹öîÆÖ¹£«ÉT QéàdõâÄt,öLŽ"'ƒ|·zv~1‚*÷øÓ £bé9 ò¸U‘ŸºÚSëX\çnì$dG¨…±ðȋϦ›`ñ=Ü­s7v2Ï Ap>Ü38럘n‚ÅÁž©k Ý %ʰl?jDÃŽU>50Ù’ú¨Q¤zj±ãxòP½ZÇâ:wc—q¯5~Ê‘Oêʼné&X|wcëÜÙUFN¤ÇHâhêÄt,Þ÷ÝtS‰Z±¡1´eûQ»zûÕCô>[/b™kë)îÆÖ¹»w,ãƒÄ›*gÓM°øîÆÖ¹û2^´whw“‘&ãÄt,Þ÷Ýô*U¬C&i½›@¬OoÈqÕƒGÅA·Ò´{¼ RX\çnì„ÂæžÒ9þaƒŽ‰é&X|wcëÜM; œ7ì»÷âÄt,¶û¾¬‹$<}ÌŸ)ÂL\ôB•HG©Ù½ÄØÆU"Kíñ%•£¶uLsk Ydi£9‰éXlïánÚ:wÓ.BF ¯oŠݠꟘn‚Åû¾ï‘)¾»eÚ»¸ˆ1# 8õ^’z7¼ãFEáÐ[êL£­s7í"d,~Í‚#æ£7ê³é&X|wÓÖ¹›v28Ê®.‚-0/>›n‚ÅÛ¾ŠâËœãÒͳz7‰Hm ®$ÙwÃÃe†y-cMÍ/¶uŒ*t2Y°gaP/NL7Áâ{¸›¶ÎÝ´“Á† …cóÄ€»™˜n‚ÅÛ¾›ÈÍÄ G~ÒØ8.ŽU ë‹Õ–ÙóÅxàãfQÅJõšÂâ:wÓNB¦DM*Ò¥´§&¦›`ñ=ÜM[çnÚÕLCìè‹§®°ølº ïûnÜ!ÓÓ[”o’ÓØ8.&¬mC—@ÏÍ}7†µ‘M°•\\\çnš_ähü+W¨”¼ølº ßÃÝ´uî¦_Í4]X­;š^œ˜îÅ~ÛwC%J#œ‰FŒúLæâ¢ˆ¡ésðÉ~T®@b‹µ®),öu„Œ'Œ³12ÜŸM÷ÀbwÓ×¹›~ „]ò'Þ[¼!5`vßá?3Ý‹õ¯ïå£Â…ÂKC®šÃ".6ë(ŽÕ[ä™É¸Ø;ö[‘P¡¸>Åó~¯y±žC‰Xây7T‚/>›nÅø’oÁây¿×¼x5Ó`.1VhÜßwÏL7Áâ}ß KÁæ¶á&9× hm 0&ãb¤Ö#*›¹P†»9ï÷š/âBÒ¢ª5ˆO¼ølº _ÃÝœ÷{Í‹×ò¨Þ›P/ñ·‘ŸM7Áâ}ß «sÃÑv¼?²ºáqq6«c&8ⱑÄ_áªu,.s7µ|-þÆ¢H,zìƒNÆ™é&X| wsÞï5/^Í4ñ°y<-½i½gÃg¦›`ñ¾ï+”±¤[p¦‘­êÚd*×Ìȧ^ìI.tàБÂâ2wS˵ø»~ËcÙð¨Òx6Ý‹¯ánÎû½æÅ¯ÅßLµâ€¹ ¶KÏL7Áâ}ßM¤¨˯ñÝÝ“ºáÄŽ8ì}ëÉ3 ð¨Ú06Y"µÔn›ó~¯yñl¦éÆ­ì‹4yñÙt,¾†»9ï÷’ëoÄ‚5L-êšû™©™éX¬÷}7Ø .&È[¦¥ôˆ‹5_`‘¡ç–¸:â":à O}$Ç5£U|Þï5/ž„ zàãÇEù <àn&¦{`±¾‡»©ëÜM¥ó5Y”Ìý³ÉmàÅgÓM°xÛw ¦¶ƒojØW—Œ‹Ðç 'œ3$õnØ…+ÚÌìŸJaq»©|’£…)þ4o;¨ú'¦›`ñ=ÜM]çnêIȈEù`¢Ž e/>›n‚Åû¾›V»½Fh“q±ÅUŒFxIë†{U 6a+%U/Öuî¦^„Lq‡ˆ+SG^|6Ý‹ïánê:wSOB¦E Øâ­_6°Ü{ñÙt,Þ÷ݘZÞp±¨³z7ñk5¥±[£^lÌ]SX\çnj»†/´â¬Çø£ìæÙt,¾‡»©ëÜM½ˆ¹á ™‹ ”5g¦›`ñ¾ïFKSk¢Ìé=SäÆX‰C\KM娴ÎÝÐ9U#òWòCmqäÅgÓ=°Hïánh»¡³™F‰ †…q2òâ³é&XôÝP£d5§=…‹ñþ)]X¸e–_{¦"umÐ?Lñ¨´ÎÝÐ%bÄdE"«lÑœ™n‚Å÷p7´ÎÝÐIÈh/Ô{áHâ›f¦›`qÐwSÀÞÄÿ­ùu¶ÕÛLÙ¼cv®sžÚÌzeM/Ò:wC×âoF³°[‰´xp251Ý‹ïánh»¡«™¦«!‹;&‹^|6Ý‹£¾n½{ä˜äi8Ve‰øŸR=­'µc"JNêó~¯yñj¦‰·dÃÈ$yTýÓM°øî†Ö¹:›iª10Ás3ÊnžM7Áâ ï&"£zÁqZ-YÇá¿o³Ïª¨T\”xyÅ­"sÑÌÌÔy¿×¼x B™Y+ÕÚ`GøÌt,¾‡»¡ufšÆÌXŠác€Å‰éXäû¾ T ³{|ù¬œ«U± ¦¥4Q/V†Zqõ©j ‹¼ÎÝðIÈHC¿þ±}¨²›‰éXä÷p7¼ÎÝ0]øQâx\Gý¨ÓM°xßwX´Êxüˆrgý¸8*El&>d¤’z7 Q# ‚ÞZJÃÿ¼ßk^<›iâ‡H¤Ó‰}Ðá?1Ý‹ïánx»ák*ÞÚLÜÝÁùß{ñÙt,Þ÷Ý ‰ÍŽC{¤&ã¢u.ýØ¿ˆ êl½Xâµ…TÒÀ½›ó~¯yñZü}HÖE¶½ŸM7Áâ{¸^çnøkª¹[‹’Þd„ÅgÓM°xßwÓ¢(êÞÕz¤›Ù~Ôf5.,îiÎö£–<Y#?–‹‹ëÜ _"6Vzô¿{Ô‹ÓM°øî†×¹¾—â…% ¢QoøÄt,Þ÷ÝtiÍâ±#—›™‰‹-lŽ”Ž{zÿbEŠBŽÒR<*¯s7|6ÓD…›n‚Å÷p7¼ÎÝHù”Rs¶†õ½÷^œ˜îE¹ï»éP›±H2#Fi¶ï¦EhëªYŠfã"©i‘5~xj®_Ö¹¹–G9ZfÑ<ÛuðF˜îEyw#ëÜ\‹¿¹6¬ý†Œè€»™˜n‚Åû¾›Ž½ÀMQö%Ž%>qéœõžõ”ÆúQ cFÄã3(§±!ëÜ\"6àbèÒ‘ÞÍÄt,¾‡»‘uîFNB&r±ÎÊx^|6Ý‹÷}7½ITn8Õ¨ÕÇG\ìÆ(’Å<{ÖqQâ…eUZ|†YFõ¼ßk^¼šiÓ Uà0G˜n‚Å÷p7²ÎÝÈIÈ`xÝÑ)uÕ(.>›n‚Åû¾w/Mã‹w,íNÆEïCbÐV,žÝK =Žõ8Ò’sý²ÎÝÈIÈxÑ(ä=êj£õÙt,¾‡»‘uîF.B&BG¼"-6âQ'¦›`ñ¶ï†k AjqùBžòøè£R$·GÜ­*ëÜœ„Œš‰k‹w‡·QÕÿlº ßÃÝÈ:w£!ƒ9oŠ®ÛHnbºõ¶ï&òSÅj¥ÈO»gŽ%踸cä :Bä²ûq¨?úUž›%ÖuîFOB&ê?gŠ2Bê‹Ó=°¨ïánt»Ñ‹qˆjGIe΃ìfbº oûn0¹TŠ«•Àe6.B¤¸qo])ÇÝ@ï¦v‰?ãõåEu,®s7úEÈ`Ý£zŒÜÍÄt,¾‡»ÑuîFå+ØUöcKüèLcbº oûnÐøŠ/®ÝrZŸ¸Ó¨K¼}Zv~1jë.• Ÿ×§°¸Îݨ^C‰M{éñªŒï;ðâ³é&X|w£ëÜÚùšd15hÝ·:z£>›n‚ÅÛ¾>ö¶aìÉÚg¢7âÅ¡`Å©³~ÄÅxmyûP$=u¦¡ëÜ^ƒPåoÆw¤É81Ý‹ïánt»Ñkyz5-`et¦11Ý‹·}7'‹ª-ŬÙ9 ìfE`7«Š€êREÉ(×¹½šiØä¡hæÀ‹Ï¦›`ñ=Ü®s7öµø[¤ÕV¢í¶™˜îE»í»aìàw¡`ê¬+šß ãnö|Q[Sm¢µ÷šÃ¢­s7öµøMìØ¯`#¸‰éX´÷p7¶ÎÝØ5…ü­GÒ©ñ´¼ølº oûn¢V$.‘å€URî81ÖÈçT4Ë£2&¯qn`®¹8[çnì$dŒºn‘ ÓHYsbº ßÃÝØ:wcrý4îk):òâ³é&X¼í»a„4¡.‰¦&ûn0fM‘xvñ'ã"Cï&>¢By<‡ÅuîÆ¾GüŒ%àEƒªbº ßÃÝØ:wcW3 ³ÇãfÕœõOL7Áâmß GÁÈÖ¡sÚâd\äbZ±`\ºåç4$b¢j|¯5u¦aëÜ„ŒQµbñÆulLL7Áâ{¸[çnìkñ·•xZÑí5ân&¦›`ñ¾ï†îŠ@1¹#üˆ‹%Þ€ºþ’ó‹dXo£ŽÎ›ÔY¿­s7v —ãøâ‘ŸM7Áâ{¸[çnÚIȰ’GáÂ}0…:1Ý‹í¾ï†ŽnöR! ’ÕGR"ìǤF..Rï8<ÚÅ,¶uî¦Õ«Éˆ{ü¼¡‚ØÄt,¶÷p7m»i'!cà ܼ·>ÚP41Ý‹÷}7„I ch0%õQ™kqÌ‘dšv½›^Ùm‘sj–¸­s7íZ¥J¥{7êeôF}6Ý‹ïánÚ:wÓ®åQñ¬QsÑÞG{¦&¦›`ñ¾ïæØ…½kËK:.Æ…†Y+r¥$ =¨Vi‰‚1…Åuî¦}-þ†¬*cmÍHÃbº ßÃÝ´uL?ÎÀVÓTn'¦›`ñ¾ïSÀª®el½¿k•BÈR%§Éxª^!žRü[ÉÅÅuî¦]"6aÿÐsd|àÅgÓM°øs7í$dÐ=] ÖlôF}6Ý‹÷}7D="#Ä•«x¶ï†ªDPu\³dûQÉ vù<0æv„·uî¦]ƒPJÕ¹tóÜ{ñÙt,¾‡»iëÜMÿmÊ}¾ν'¦{`±únœ¨‚lILÇÅ@STе»åv¡ba\s*X| %Ý û:wÓë×ðE£ø.d7Ó=°ØßÃÝôuî¦_Í4)œµ^ÍFgýÓM°xßwpÐÂEÇ–{:ûQÍ;Er^Ärþ?®ZDDÈ£–œÞM_çnú51<˜É ubº ßÃÝôuî¦Ë•x:'M¨ŒTn'¦›`qÐw#ÜŽ5 V2ôËÉ£¶ÀX÷ø{rNƒ ìLMYÅ$¥±Ñ×¹›þµˆP3è£ÎL7Áâk¸›ó~¯yñj¦Áù[CŸ˜Ôf¦›`ñ¾ïFk%ªñ­}©É¸(+áD.¹#¼|Ó~ÃF.uã¡·ŽÅeî†Ê5…AˆOŠØýÉÔÌt,¾†»9ï÷š¯Åß)”Þ–2òâ³é&X¼ï»‘È« OŸÎõãbÃNcRéµä46ÐjH šP8œÂâ2wŸÿõH8­D…Ú‡Ùͳé&X| wsÞï5/^Í4µÖÈÁZ¼Â^|6Ý‹÷}7"˜,Q÷æœ_ÕKïXP’½áèÝíE"=%.šÃâ2wCåj¦ÁÞ((å`ÝÀÀ‹Ï¦›`ñ5ÜÍy¿—¼X/#ŶNT6÷<êÌt,Öû¾ŽÊ(Òk6iɽÄE’†TŽâå“Ôd”xÖÁÞ*žsq±®s7õj¦1ˆJµ ÛûóÅ™éX¬ïánê:wSOBFµ›€é–28%ž™n‚ÅAß)io`~=­HV,Ã$WOÕ‹?ë%~d@¹G<.G±¹ŽÅuî¦^ƒPá¿Cóô¾ufº ßÃÝÔu„Œ"ý‚ÞYáÁV”™é&XôÝDͧˆš­1óX£Ì4/…’½áÒSr0± 2gu»©'!±›NJ%3ðâ³é&X|wS×¹›z BaVšUœõÏL7Áâ ïÆŠ›vêå[vÿ"1Nâ‡ˆŽ©¾›¨%2TDF/ÇÌYÿy¿×¼x2èI¨Ò é1:Ó˜˜n‚Å÷p7u»©—ˆaáP¥C{àÅgÓM°8Ø3Õb8Ð4¥±‹#—ØG/%¹Oã#I7*Òˆêä×¹›z2ñƒub]Á`Úffº ßÃÝÔuî†.B¦ÇóÚJ¢ª *‰éX¤û¾œÂ@§8J\ÉŒZœ{‰!E±P%Oö†c®¿I!Ô‹9MÆó~¯yñ"dJe.Þ¡µ8¨ú'¦{`‘ÞÃÝÐ:wCW3Í!zʵH<;/>›n‚Åû¾› 5^ Ö\9ÛZ¬jE\ÄIarG8i!ÈÉÆ?zFcã¼ßk^¼™¨ãY ;êÛŸM7Áâ{¸Zçnè †4VÆó68™š˜n‚Åû¾›B%¾v S,˜ÃÚãÁùâÄt,ò{¸^çnøZÅa-“Jƒ7êÄt,ÞöÝ@¬¦õ£»5c2.J¤Æ¥›a1q2.Òª%‚¢³§v„Ÿ÷{Í‹'!EC#¨V™ŒrÔ‰é&X|wÃëÜ _„Œ˜x4`à§ÄÓM°xÛwC‚¯.„] ¹™)\LÚÔIK<¸™º#.ºFáZ{‘žãnx»a=)n†Š4Z¢l ¬93Ý‹ïánx»á“‘c¿©»˜×ÁÉÔÄt,ÞöÝd²ô`gÓM°xÛwCaçC·•ìù"VbE¼6Ê \sZ+ U,©Ò’Ñž:ï÷šOBÆ#cu«EB=ÊnžM7Áâ{¸^çn¤\Çnh¹u2NL÷À¢ÜöÝZÙ;“gëE2CB®IËÆEkE@™ôÏœÆ2e»‘‹‰â£8î˜ØxñÙt,Ê{¸Yçnä$d°˜,âiäR<êdœ˜n‚ÅÛ¾*®zŸ[‹d3£¢*ÇÁ8Çœ<_ÄàbQð$ì–ËQe»‘“aàcó‡ëhòmbº ßÃÝÈ:w#rÒjŒÁ‹x÷“6ÚÎL7ÁâmßMue÷Ââ©&ëÅê‘Ðq<(BIMFQœ‡Hqƒ¤@ŠG•uîFÎfœýÒq€B#‰é&X|w#ëÜ\"6PÒ¬¥bרÀ‹Ï¦›`ñ¶ï„Š“˜&R3’5t\¬: #TÕ¤&c@½ñÞêÐêHaq»‘³™Y ºuÖG'SÓM°øîFÖ¹é×AEóxjºÍiLL7ÁâmßMUÁT?N+g$kè#7Å•7óOnò|Q$RúÈrKÅ!e‹ëÜ\"6QÖbI-NFoÔgÓM°øîFÖ¹ýj¦‰<¬ˆQ”w31Ý‹zÛwrD¨ø'DÙ’q‘žXHd”*ÉùE9V!«C„ˆ9Å£ê:w£!¯ÇqÇŽ»ŸM÷À¢¾‡»ÑuîF¯åQàG¹’5ilLL7ÁâmßMÅ _„§HÊ *‘Œ‹…±W‹"›ƒx2.r/Še r[ªU×¹ýZüÝk@b®C/>›n‚Å÷p7ºÎÝèÙLc΂M¢àüï½ølº oûn0çÕ0Žê´ûå{/öZJÃLƒG^Þ§ôËqk¸k«®ÇB§ ×¹= ™ª”Äq…ÙȋϦ›`ñ=Ü®s7úµ< Ãç=ž(Þ{ñÙt,ÞöݨK¯Q2jã’€â"ÎQ{‹r¯E†kSÉšâbEÛU GRŸÂâ:w£í"G=òNÃk£&ß&¦›`ñ=Ü®s7z Bõ‚ÙwmÅG bÓM°x¯wãU*æ¦2p:æú úÆ­5Å"‘iÉ÷c\TtíÄ«ÀL{Š»ÑuîF/B=¯•±žnàÅgÓM°øîF×¹; k؆ šÖgýÓ=°h·}7QUñ@D$›\§™âõâ§¾cë¤ÏCÛý¨‘£v‹Ko5u¾hëÜ„L‹¼§¡M ª|ïÅgÓ=°hïánl»±“‰|¥Æ;<üc>òâ³é&X¼Ÿ™’Zã rÈw{ó™bð9*NÅSÔɑЕõ‹?q1 ECk„4ŸGäXÎÝ_M¦Õ œ_–ÙÍÄt,¾‡»±uîÆNB† ç[#ûtu2NL7Áâ-wS=Ê#œµ»´>ïDû±7¼–ˆkØuÕ›d\%­ YŠÌ>…ÅuîÆNBâæÄ‘}Fi:8Ó˜˜n‚Å÷p7¶ÎÝØ5U!ý'ÆF•ÆÄt,´Š[%7/¶¥‹ïã"æÃ0¨ÑÙéÓw“©#Á\>®>ZxSX\çnìZÅ-B?Eòé#•Û‰é&X|wcëÜõK RàÖ»ðh+ÊÄt,Þr7Yb·Z°ð©J’»G#µ±³EN—(6?sè@>?[R¶ÎÝØ%@Ü wd,6RŸ˜n‚Å÷p7¶ÎÝ´“éÕ¸SÁÚ tOL÷Àb»ån´7L]zo¬’9"D\4ªÐɨIuÍò¨VŽԠוšëoëÜM»ˆ‡ Ð¬+£-šÓ=°ØÞÃÝ´uî¦Ñ%)"©%ªšA¥11Ý‹·3S‡HiÇWj1ÚŽ³þøEÌÐ.´ÂÙóÅ&QfvƒÜñgBd‹ëÜM»ši°@'¾+GTýÓM°øs7íZüÍÇ A©Î>Š‹Ï¦›`ñvf*Š"qSå(v“õ¢›AåÔÜññ‰‹?ûIK+Ú%u¾ØÖ¹›v2ñ®¨Q=Dâ9Ò*ž˜n‚Å÷p7m»i'!Spž¥ð ^œ˜n‚Åû™©ZZóF8¯×žÔžªUÔ UÁ~­šÔ —xuõ(®+3yOq7m»i× T©­ÔÚj wàÅgÓM°øs7íl¦1 ¼¢#ªõ‘†ÿÄt,ÞÏLÅÿ^¡5\ˆzNÇY?M¦ eç4 Wñ&hU{Nµ­s7í$d±¿(ZjÊèúlº ßÃÝ´u¯ÄSÈ ´½ß{qbºûýÌ”X1(Oyñü,1ºn ·åM{zNC½ —bñ“£6Ë`±¯s7ýj¦1‰Œ‡/ÅF^|6Ý‹ý=ÜM_çnú5Å­íñ§Î4&¦›`ñ~fÊâ¹èO1˜Ôd\ Uò£]Œ2Ë8>z7¡Ö¥Š;…Åu„ŒáðmãáÓM°øs7ý"dJ¡xs£Ït4K<1Ý‹÷}7…F¦"MÕÔ\ÿÑ ñ~3mµPJc}7Pöˆ›†õÄ55KÜ×¹›~-ŠLØ «ClTõOL7Áâ{¸›¾ÎÝôKÄ&.""'0pÓM°xÛwS#ªÕîG5É”|í)oBØVH‡fZ..2Fè­¡£Þ5ÅÝôuî¦_ÄM ÉŒâ¡ úQ'¦›`ñ=ÜM_çnú%bƒHb…¢î½ŸM7Áâ½Vq­Øjó™ÒÈÈðý¨PË©ç!˜NÇEÒj…f‰-…Åu„ C‚'‡Ü‡õâ³é&X|wÓ×¹¿ši§÷FÎCnbºý¶ï†ªt‰‡/RÌøþ úåÐ*3’L‰2Y³:päI³vòy÷Ýï½èëÜ׋Eèv7áÑ&†‰éXô÷p7¾ÎÝøIÈh¼¾5ʇŽ~¯ŸM7Áâ½Vq¤ÔÅ#”GžÙ,«UL~´HoY8³0î£wS@h«ê¼iç;/®s7Îç äkTtp251Ý‹ïán|»ñkê`¹[)£™©‰é&X¼í»!™PÊèQ#åw¾)UF‡·ƒƒÉò¨Å¥»Fð‰95KìëÜŸ„ŒG*ÎPG¯þŸM7Áâ{¸_çnü$d9TĹx‡÷Qvólº ïw„cv©Mâ Ôq±t*]œ„¢vÌž/j…Q±•–Ãâ:wãg3åˆxƽ ±ølº ßÃÝø:wãW3 z¦Í })ƒ“©‰é&X¼ß®Û ®õQòLG(UX@à7{¾(éC/«D©šÂâ:wã—ˆ—c}{Å´þÀ‹Ï¦›`ñ=Ü/s7\Ê5 ºPJ¼+û=:3Ý‹ü×÷òÜ(N¥jvêÑ3#*Õ½[ÍÖ‹Ö¤¡§Ü A•Àây¿×¼x5Óàµb›¸›™éXŒ/ù,ž÷{Í‹'!SpˆVM!#=òâ³é&X¼×»iÒ2þÊœìG%P°=ÀÜ,Ó´ó9_†>7ÓÑ‹Ââ2wÃål¦S?–ËÅŸ÷UÿÌt,¾†»9ï÷š¯fgèQÜ´ÞÏLÍL7ÁâýŽp YIiÄÅŽxd»ZÍõ†CÕ»GŽËŽõ‹™õ¼ßk^Ôë Â‚‘ ”5g¦›`ñ5ÜÍy¿×¼x2BBÒ¢Q ¼ølº ïw„á;{¾èê¹á  ¥ûQ [¼¾,ÀX453uÞï5/^ÄâÇaÑIãÑõÙt,¾†»9ï÷š[üÕ_¤cQÞŒ¼ølº ﵊ S|çÖ½¶šÝ…ŸÉ$%2(Å3$,âb$- ,ÞÇ2ý¨çý^óâEÈ´ÞêpzßU<3Ý‹¯ánÎû½äÅz BE)~Ô±{÷Þ‹Ó=°Xoûnâ¹V1ƒ8ˆ”ÌÚ¶C®r‹ st $ˆx‘£H¤¸X:÷^Sq±®s7õ±‰Š¶»c)ƒªbºë{¸›ºÎÝÔߡ⿖j¢Åé™é&X¼í»ÁöÖE†2c2.Vìz‹È†Mã%É£2úmzdÈñ*àù€ï¼¸ÎÝÔ«™Æ:kŽB~ĆOL7Áâ{¸›ºÎÝÔ“‰Ô-jšæë}WñÌt,ÞöÝpmh%E –£_ޏˆîŒw@Ò §°@&Õ(Q[£ÈTS:pçý^óâ5á_°µ56¨ú'¦›`ñ=ÜM]çnêIÈsR&,£ý‹3ÓM°xÛwõžˆõ^,Þ!=u¦‹Ý[ÄUì¯Ù9¨Tûñˆ],‰Åuî¦^„Ld,„ ò€Qvólº ßÃÝÔuÄŽ±÷t„ÁןM7Áâmß D€ªÈ6kr®Ÿ1HÜ©{Šøáã@Då‹In’ËQ×¹›z‰ØÄD£ZfàÅgÓM°øî†Ö¹¾¡$\OœÕf¦{`‘ïûn {V¡˜ÊaC>®Aô¦µÜY9¶°êkhª^äuî†/B&â´®02x£NL÷À"¿‡»áuî†OB† ‰/n5õA÷ÔÄt,Þ÷Ýt¬Äîñþ–í»ñÈ<Êdü朌‹èõñnñGJ55§ÁëÜ _Ë£Šâµj¤äƒ“©‰é&X|wÃëÜ  B¹ ¦m£9‰é&X¼ï»éV y"äy“qÑã*ØV d6’q±QT×o€xîSsýçý^óâIÈD¨‹‚¸Rø†G^|6Ý‹ïánx»ákªG)Õ¡ÉÒŠf¦›`ñ¾ï¦WÈl4Š",’Ål½ØZÃëÇUOöÝTeì·òR"$çzÃy»á«™&Rp¼$KëƒMï3ÓM°øî†×¹¾Dlº“aÓz/>›n‚Åû¾›¦Ö Þ}Èž¥46ó¶.­ešvޏ/ƈÈÞ=R ÊhO÷{Í‹~%ž#cÔh U<3Ý‹ïánx»‘“©Y§ñ±ÈzÝLL÷À¢Ü÷Ý´xæªrÓÀS6.¢•©ZnÉ=Sµ Í½à˜±gv¡ž÷{Í‹õjO$ªØ¢?s'¦{`QÞÃÝÈ:w#!CZ*¶¢Å+|äÅgÓM°xßwÓz!h8ÖRXD\ÔH0±ÈWñžËÅÅÖÄQŽÝ툋ßÞxq»‘/B&`ï‘®Ä[gäÅgÓM°øîFÖ¹‘K8CÃùñØE67¨'¦›`qÐwÓK¤§é"gZgŽ¸Ø´xüÖQaAö>­~&õÖå‘[Çâ:w#× ¾a€Œ8þmàÅgÓM°øîFÖ¹9 ™ñNJ«QÖÈ Ò˜˜n‚Åû¾›À¢u¨+RÅd\lQèõ¸KQ³ç‹ _g꘱"ïç"Ë^\çnäZe­’@ß¼¦P'¦›`ñ=ܬs7r‰Ø8äk{qF bÓM°8è»1Ð.\°3²äûnÐáU£ÆÓ›Ôðg,ã°F¥¦Ë×ãâ:w#W3M…¬ªõŠyýŸM7Áâ{¸Yçnô$d¢l0öÅÙ@{jbºõ¾ïÆ s©"Zo<Ë£¶½›ŽŠ5‡ÅŸ¿¡Ã).–WhOaQ×¹­_M¦U£¬ÒuäÅgÓ=°¨ïánt»Ñ‹ä)¬ŒiLL7Áâ}ß âZå†D³æzÃQl2ÆìÍY³³Ä‘ ŠIDT8‡&ã:×¹½´BD }^|6Ý‹ïánt»ÑkyT/èMÕÐFoÔgÓM°xßw£Ä Ö°Æë#§±‹½cO–MiNïæço.Þ4~zƒ¬L)),®s7z2C’‚wÆèdjbº ßÃÝè:w£'!#®X8Ô¡#Q^|6Ý‹÷}7Ü»ºa º±fëE1ÆŠofìGOλËÑáŠéë\ŽºÎÝèÙLƒ4ºU/Ò†û4&¦›`ñ=Ü®s7z BavÕ4Þß ÜÄt,Þ÷ݶrˆGÅ—ãnâbFk§Ò¤õšÔðw·(;6ª[Æ×¹½DlÚÁ)”} ÜÄt,¾‡»ÑuîÆ.âH "‹’J4ê Ÿ˜îE»ï»©Åf5<âyOë£B˜C Ž[²7Ü{ÄÔ¨°I¥¶c«Î2m»±«™¦3ôæJCØxñÙt,Ú{¸[çnì$d¢|h«{•Êà:1Ý‹÷{¦¼GªÈbW«Ù¾›b‘/%.•Ô\ÄÅxàãH%RÝÔY¿­s7Æ—ä‚EiÛ¹pÕAv31Ý‹ïánl»±«™&Ê@3ЧmôF}6Ý‹ƒ=S‘O+ÕÒÐÔžÒð‡¬b„ÅáTJ„ÆTŽZ¾u÷Žåx_"…ÅuîÆNB¦)¸j™ƒî©‰é&X|wcëÜ„ŒEúÖ" ’ÓHabº ï÷Lµ ½³(u#YLï_lmü²Öã-”Ôžê¢o›Ââ:wc—ˆªñš´.#îfbº ßÃÝØ:wc× TQìajáœLML7ÁâmßMdÔÉfƒ’YOsÄÅ(3Áj§¨ü²q‘¤Ð¹S=Y/®s7v2s7f‚ úQ'¦›`ñ=Ü­s7í7âx“;×Q?êÄt,¶Û¾BÛ:D¡9œŒ‹ 5,Ü47×ÿó·F1KdŠNõ·uî¦Õ‹ÅR+‰ÊXú ccbºÛ{¸›¶ÎÝ4:KùxÊ\¸Ë¡«}ïÅgÓM°xÛwCQ*ÖbBÅnv/1A…’8^B¯ÊÅEzŒ[‹p\¸ÖTŽÚÖ¹›v5ÓìÉ[ ÔÓ G˜n‚Å÷p7m»iW3 {5kÔ!X6ðâ³é&X¼í»‰ÂÕm|玹Þd\¬ñþ‰,µ@•¢¦ÎúJµU üw·VSó‹m»i'!ì MŸ?uäÅgÓM°øs7í±A]SKkÒFJ)ÓM°xÛwƒõô‘“AI²WKÃÎõèƒ3IÖ‹ÕVÿÞ½›å™©¶ÎÝ´“‰”³´(4­bνŸM7Áâ{¸›¶ÎÝ´“«V]êüƒ~Ô‰é&X¼í»©•fÅ ƒ¹¸XÕ…4¢bÇ?“½á÷t·€2UKæ¨ëÜMû­™¦”¨!"#–71Ý‹ïánÚ:wÓOB¢n¥{üì½'¦{`±ßöÝT†Ž~!‹pîÙ9øPô5X’ÌÅGŽ*,Ô#¥g ?J‹}»é'!5©ª‘¯)¥LL÷ÀbwÓ×¹›þ%bãŠ>ŒÒŒ}7ÓM°xÛwS+ í¤Õ2²ŠG\¤‚=0`#”$÷iÄ­¢ƒ¹éÂd©¹þ¾ÎÝô“‰k |J¸gäÅgÓM°øs7ý"dL[¼l¸Ocbº oûn01kÍÐ:qjªüC\,+D¼Hdt¡ãc·Mi¥WjŒþ–N©¸¸ÎÝôkŠ£.cK:ân&¦›`ñ=ÜM_çnúIȰJ¼þ±m¢Øð‰é&X¼í»i"\M{©Ÿlºíéû¸ØÙsbñ²æÓ•ß稪êWãõ•œÓèëÜM¿ši le-WMÛLL7Áâ{¸›¾ÎÝô/BF°rÈ¥pôÀML7Áâmßb?gŽã ÊÅEÃðb\†÷ÂSéïúnp×»—ˆª™SX\çnú×ò()ކœ¿ ¼ølº ßÃÝôuîÆ¿k%•S½Q'¦{`ÑoûnähP(X…èzhø'â¢6¨ÿ“C™M(…E›9R±¿"£UìëÜ_ƒP˜e+…¥5tøOL÷À¢¿‡»ñuîÆOBZDØÍL›n‚ÅÛ¾›H;䪶 çâ"“¡¾ì HÆÅxga磃·”ÔŽp_çnüK€X#'n~i¼ølº ßÃÝø:wã'!Ãá˜U.£¾›‰é&X¼ï»Á‘BóvôÀôDÉwô£rÃÐT†?‡“‰¸HÕÜŽ]{„×\½¸ÎÝøµ<ªv7l7-ñÏŸM7Áâ{¸_æn¢z?φñ¾¦Øh}g¦[`Qþú^~æ±zQ Èˆ¶Ô›ùcß ªÌÈpØo),Lky¡ðIÅ^âL\<ï÷šë™x £q³’å¾^œ™nÅø’oÁây¿×¼ø%@Õ”™Ñ Ò˜™n‚Å[î¦u°˜Ã/’2í ýAïF¤sá Ç\&ㇸ¨qIT™µéeÊà~çÅeî&ª…“‰\úØ%‘¼ølº _ÃÝœ÷{Í‹!ÓóØ6˜_œ™n‚Å[î¦B7²°œÐ*>ï÷šOB&¾ôX™•z73ÓM°øî†×¹> ™"Eˆ«$}^|6Ý‹·}7GiÅSTG%¹Û¦»s$¹Q5FŽÛ“Ü äG¹ÔÚˆÙ%³ õ¼ßk^¼¡¢€@ûküª£óʼné&X|wÃëÜ Ÿ„ è>슲f°ómfº oûnjA½ÎIjo©}T­8“@s˜Ø$,â¢DI¦^±ƒµÆk,…Åuî†/B&‚Õxã”2êØ˜˜n‚Å÷p7¼ÎÝðµøÛˆâQ-EF›Þg¦›`ñ¶ï&RLl_#RæÔ>ò 3)Ô Û…ÃwÃWé ÍŸ}ªîñ×¹¾9´9:Î  ÜÄt,¾‡»áuîFNB†M\Z׿ñ¸Þ{qbºå¶ï¦F¡ç Q"G `%wÛD™ˆ3U&ĶÔ> NF î…ÔÓT ã÷^”uîFNB¦4±êQ;ºŠ'¦{`QÞÃÝÈ:w#t5|«b_÷¦ƒìfbº oûn*6ËT±cXÏ«…?»mXkoÜìÓ:“Ømƒáyb (LЧ°¸ÎÝŸåCm=B87‚.ò½ŸM7Áâ{¸YçnD®`Y˜™FIÔGoÔgÓM°x¯wC@iT‹…2«¢Ž¸XKÇÞÐCš“qÑ”‹è±N=âk..®s7r-B+E9耻™˜n‚Å÷p7²ÎÝÈIÈ*©xX[EItïÅgÓM°x¿#œZïÇF,ÇÎî¯QbV㦘Kî|³Â¢•¦akf/ñy¿×¼x‰Øh¼‡‹”ø‰£“©‰é&X|w#ëÜ|-²VŠS³Qvólº ﵊†¢ñô‘6JïB aqc%ò~:fêÅÒ#µÅèLQõÔY¿¬s7â_‘´xÇNòÁÉÔÄt,¾‡»‘uîF¯fR')Ý¥ ¶hÎL÷À¢ÞöÝTªXÑ Á-]/ZënÐRjɽȾ;=eÑÒšÁ¢®s7z‰ØP¥cyT—ÑäÛÄt,ê{¸]çnô„jîB†5`£Ž‰é&X¼í»©8OÃ^Œ¡íPFLñ¨ |¨×¢ñø&'™)ŽˆŒÇ=ÞÔRgýºÎÝè5Õª÷cIF¼?^|6Ý‹ïánt»Ñ“9$¤1.[©¼ølº ïûn¢‚¦PS;$N3ç‹æÚí»ê*Ùý‹R#ÇÇG›ÇÌÔ:×¹½Æõ>ÍOL7Áâ{¸]çnÔ.€E-Å^±`|”Ý<›n‚ÅAßôéB7¬rMañçoݬìÃLžõã¥+™˜·2ÿ΋ëÜ^Ë£¸Çû¢õxMŽtÃ'¦›`ñ=Ü®s7ÚÏ”åÓ¬IØk6Ââ³é&X¼ï»)ñ iècÃÂïl?ª²nŠå6Øæ“Š‹ 1• P¶\½¸ÎÝè%bƒÂ¶´ÈªiÔ71Ý‹ïánt»±“Á¥‰ ³öÁÉÔÄt,Úmß d–¬¢‰önÄÅÖÌK-hh%§á·€®Q0z¤Çs ÿÞ‹¶ÎÝØ¹<ªà-^Ýx´‰abºí=Ü­s7v5ÓX›n‚Å÷p7¶ÎÝØIÈ„ç¥Uœ…G6ðâ³é&X¼í»Abpò^Œ‹¥´§~þvHÁöÖ{¤åÌIÝp¼´FHtŒ`§4üm»±‹AÏ,æõÛ°ïfbº ßÃÝØ:wc× TgÀŠ;6&¦›`ñ¶ïÅbJR.G-ß,j¾Å­Þªäæq¦!8V—Hë«Óô-ð×¹;›i Î0+TÚˆG˜n‚Å÷p7¶ÎÝØ5…ݹñ¢DÇ倻™˜n‚ÅÛ¾›È«ñ­æpÊê£F8Ãù"W*%ʾd\”R¬äÿ)¹ÑÖ¹ó³,Qž¢óVºŽââ³é&X|wcëÜMûj¦‰ï-^’:RJ™˜îÅvÛwƒS…kR"Om”Õkhš!0½zZU±w¤;4srºám»i—q” ½#ö·71Ý‹í=ÜM[çnÚ‡ñÒ¹t¯á˜áÉÔÄt,ÞöÝD©Ç-’ÔÆÝ…³qQÑ_„zÁ u2.j/NØ4'ºäXÎÝ´kñwà¾x§>Tó›˜n‚Å÷p7m»i'!SݰÑíÏ#¸‰é&X¼í»éZK‰àÈVÍ[º^,ŒÇÖ#4ú<´ý ªâ©Ç ,…Åuî¦]„ŒßÐYìƒÿ‰é&X|wÓÖ¹›v «têÚ+ŠªŸM7Áâmß ôê»dNKµDÛÕ¢VNÕršŒˆ‹Z[¯PŠwX..®s7í$dzcj_ÒÚhÿâÄt,¾‡»iëÜM»¡ŽÅdÿ(:ªŸM7ÁâmßM”k˜Ôèø/œòýp¾X©t(4áP$» øØ!Í×Z3X\çnÚ%bãXMñÚh#nbº ßÃÝ´u+Øy3ZãÏ'¦{`±ß÷ÝTõÞªáоgÒÌ£ï†KT›bµ¡Ó7¥‡®ô¨6ÅýcþèÝ,c±¯s7ý"d¸ ‘¦E2][Q&¦{`±¿‡»éëÜM?›i„1~ÁñªŒçvàÅgÓM°xßw£-òËø»±ö–Ú…qÑzïÞ=‚H|JrNTemE+Þ_=¥wÓ×¹›~2±·Åk}´]zbº ßÃÝôuî¦_Ë£¸Äk›]qæ4ðâ³é&X¼×»Á/@„³´s/qfN£VÌWñÏ‘ÓdlX‹ÓJ¤¹,œš™êëÜM¿‹ø]¤á‘:ÃÄt,¾‡»éëÜM¿™^TZäb…G:pÓM°x¯wS„ÀhF~ê)YÅÏœUD Jåùqý÷q‘«7jq¡Wp%),®s7ý$d,ŠbW+Øü=ÊnžM7Áâ{¸›¾ÎÝô“ ‡P=&õê¨Ãbº ïõn0Øñ¥ZÏMÝÝpЍfBl#8æâbï‘ÖzkhIÿ¨A.ïÓèëÜM¿šiäP­íB½ xÔ‰é&X|wÓ×¹/çPb/Q@0xwÄʼnéXôÛ¾›J¬ب¸YÏÎ/Bcƒ:y›šW=Ï4›¹Ȫ55KìëÜ_„ ^bˆì *‰éXô÷p7¾ÎÝøIÈp#gªÅŒy„ÅgÓM°x¯w fD%&”H9í©cG@Y0ÿØHb9Ç>JqQ<‰Ü,±¯s7~2­¶‘GyŒåt÷^|6Ý‹ïán|»ñ“1£Z±™^løÄt,Þëݰբ[D'–d½X1œ]°(ªG®™Âbùf„‰IÇV'o9 _çnüZü]µcé·ÄTÓM°øîÆ×¹¿ˆýÐñõHņ^|6Ý‹÷z7Â]°7’"8ÖTŽŠq`ˆ9vdšT5¥Éøó·v(Ý4ç‰PêLÃ×¹? íª*6ÒdÐ=51Ý‹ïán|»ñ“i®¬VÂG<:™š˜n‚Å{½1ÖN£È=!7|ÄE’cs(Q@‘RšŒØˆŒ}Ä„ÞTf),®s7~6Óp/\)jâw£õÙt,¾‡»ñeîFË%b£‘JEYdP$ºõâÌt ,ê_ßËO\Œ“ ‹©Y‹‡èx+G/›UËîÓp¥© c}l¼ÄX<ï÷š/bHú2ê>ØŠ23ýÿ ‹ÇuÿöÏÿÓ_þë_ûò×Ïÿýïþøç?þú¿üýOúãŸùÃ?ÿôÏ¿üúOñþòÓßýáO÷ßþt˜~ûöío~úúÿø‡?þùsëÇA™¾ÿõ§ÿã?þgü×Þí›Ð¯?ý¿ÿÛ¿ÿ÷?ý/_OG|ÚŸ~ý_¿>ã׿üé¿ÿò·¿\ŸñÓOþéë3~ªý›ËãgüåÏ¿üí¯ÿòË?ýî{ÄEü»ï¡ý‡ï!áë¯Ïøþžþö)ñì~ãúõ)Q-}ëþûOñRìÇßæã—ðÀç3¢> ×}F™ß:ÿðMøþ3þü—ó{Ôømª~}Fõþ­Øð3þçý6ÿð·ÿôëÏ;þù bùÖøë3ØË7çÙÁÃó·ÿËŸ=ýÛè›üî·‰_®—ÙùË?ÿË?üå·ï‡BûŒŸXw÷=ÊwŸñ;H\Ÿ¡-rèß>ÃÃ3?>#õ=þ>`ù»ûñÕヌÔoþûߥƛìGÏüçÿç§þËû—@د¿Aàëy¯O”oüÛCƒÿ*cW}>åÿüåÏñ þé‡Ï›ÿòËß}÷•¹¿çõÙV¿w!È…ïíÿú_¯ßùë3šÿæµÆSQø~þãgüï?ƒ kå7`”ú­ýæ5üµ ÿé/ñúåë>Õo¥ÿî>Õk.üû?ü÷¿ûã_¾û]Žàðݽ.õû×Ñ÷ú?þ!îôŸ~ùñfÇ/ù·¿þÝþ%¾æ…—x>~çH)þM~ÿ|`ÛïŸÏçü§óoþÝüO¿}ÉþJ»ßòbßôü ¿ù\öŸþá¿þôÏÿíÏ?ý?üúS|ƒüãŸãFÅ뺶Uí_IÁ¿ý»_þ •J?ýî¿ù›ýóÿÔ?þ5¾Ñÿõþ÷ŸþÍø¿ÿí·ÿùŸþÿÒÿäq=TDDFPT/Examples/CH4-BOND/CH4-BOND.tddfpt-in-s2-20000644000175000017500000000035012341371500016363 0ustar mbamba&lr_input prefix='ch4-bond' outdir='./out', restart_step=500, / &lr_control itermax=1500, ipol=4 charge_response=1 project=.true. / &lr_post omeg=0.6447 epsil=0.001 w_T_npol=3 plot_type=3 / TDDFPT/Examples/CH4-BOND/CH4-BOND.tddfpt_pp-in0000644000175000017500000000027212341371500016404 0ustar mbamba&lr_input prefix='ch4-bond' outdir='./out', itermax=5000 itermax0=1500 extrapolation="osc" epsil=0.01 end=1d0 increment=0.0001d0 start=0.2d0 ipol=4 verbosity=9 / TDDFPT/Examples/CH4-BOND/out/0000755000175000017500000000000012341371517013612 5ustar mbambaTDDFPT/Examples/CH4-BOND/CH4-BOND.tddfpt-in-s20000644000175000017500000000035012341371500016224 0ustar mbamba&lr_input prefix='ch4-bond' outdir='./out', restart_step=500, / &lr_control itermax=1500, ipol=4 charge_response=1 project=.true. / &lr_post omeg=0.6154 epsil=0.001 w_T_npol=3 plot_type=3 / TDDFPT/Examples/CH4-BOND/CH4-BOND.tddfpt-in0000644000175000017500000000017012341371500015702 0ustar mbamba&lr_input prefix='ch4-bond' outdir='./out', restart_step=500, / &lr_control itermax=1500, ipol=4 / TDDFPT/Examples/CH4-BOND/CH4-BOND.tddfpt-ref-s2.gz0000644000175000017500000102422512341371500017021 0ustar mbamba‹s~COCH4-BOND.tddfpt-ref-s2Ü][sÛ8²~ϯ`íST)Woåa*s9³5Ÿ$s©}IÑ2më¬,z()çןn^d r½ÞâÊ3c{ŒD‚_èþØ_$ôu^ä×Ez›|øúëoÏ?$Ÿrá\Ù’lwi±Û&ù&üÛìB0.’t—p~&Ù™0É‹¥Ù‡›Õ6¹«‡¡_±W’_%»›,Éï²Í|›ï‹e–üï>Ýìö·É7ïÏß}óþýÏÉv¿ÚeÕWy‘üQ·oW·ûuº[áçâ(·é.+Vézû·än¥Û,YzÑ×_ÎÉw«t³É¿|Y%Ù.I׋WÉßÉùÍývqö6ß\f›í"ù1Ýá@x& 8¥˜H^ ÆÜìo#%¿¼û!¹ÙíîÎ^¿þüùó¢>žy¶½+²í6_äÅõ_^%U‡Õ&¹Û_¬WËò@q’Š„¬²Í®þCZ¬¶«ÍurUä·88/ŸóâŸxy‘%—Ù.]­ÑhWùÔ×ìó]¶¸»¹«§ü<-Òõ:['Ÿ²bKõòÇóïg¯’b¿ÙЇâ_è‹ÓeYÒ(Ŷî9øu|mñß/?¬n³äë ¯*ÎêÛlW»ûäÛýfI§®“ó¬Øí‹‹êú}¸Éòâ~Vö~‘üZðYÂ.ù׎é—õ®H·ùÕ.yùkŠÇQ\¬Ö»Yr¾Íö—ùNÔfGxi¦ªÈ®V’–û¢ ƒÆI¢SJïʳ¸L.î“9Bý:e—ï7WùY²//Þ¦à¯ð› o|J×ûl[]ÑÕæn¿ ÙoËåwØvtÁN?žÿüîÃW?}8K~›\=L_†£¡³\uIΪ>ßü¹¼I7×Ù|™ã‰ÔR~½Á¹ýá+<×àÿüôów¿Ó··ÉKOý3«‡øý÷ùU‘.º6_oš_Ø‚±Êø«Í=Yn\$_ûA{µÚ¬Ê®ŸWëur8^m—i“XÏué ¯•««û õüdû|Ÿ¢ö>ùŒñâñç'W«u–üÏâîËüÓÅrñËù·gh÷)k¦æåv†x~Clòâ6]¯¾Ð‡Vƒ|7ÿ”-wèÛÝjùOüHœÃnd½¨¹LÏð7¢‡ ÿp›ç»›ê4~{¶4ilŽÐªAõmsRjwô“sæ¼³ ¨G¿XÆMílùîÈNÿTJ½HÜh{—.iöÓkÍêK…ä$¤ÆÿçS–lóõ¾áPbâlumJ8)\¬³ÛVi²- ‰ó:/V»›ÛÃåÝoq’ëOý!Ý,¿äÛd½Údi×a{—Ó¤lïpî œƒeº^Ö¼]õøi{ÐÁÏoúÖGGôHxã ¡VÙþºBÖÀc@?Üet“ë"ßo.«?”.{|P%ýùÿe’Sœ„ûíªqùßÒ‚XðŒèÉ6Åÿ>µÆ§9©Ü‹÷*Ù÷äÁ»œ@]d×k2;œgëô¾Z¯sbìT^ó$ûy)¹@JÚ–ëÙÃÖÇõ]z{›&wùj³{˜ìªi]|ü|µ$÷úØLèYBî¶½Á³ÅV¼œŸ²Ys5~Þ.q:Ò ôè×»›úCó5®<5 .WEöÈ×yÕ;_.“åÃ_ße/ßÍãôû[üS㢼þȇa€qß̯þÂê¯oþÚGe-è—9öЂ ëx¼Ô=€[+™Ññ²î!ðˆ8W¶¿‡hÎ{(Ü9Ñœ¶“Ʋ!= ™+p̲îa¤U`eäÌáèz€äL(©¨½¿Gs=çÀ4^hæzp¡¹áÎÆ{4çGd˜a‘ë!®Á™u¦ÿ3äÑõN[âÎxÃy0%"Þ£9iµ6œvE ÇÓœQüœÑ"ðÙgœhÁåpgD/¡îŒ Á*Î`¸3 í40+û/̱3r„—Á+ïqpFε<â(ÇΈ+³Ñ Í@g,]K:0:cI’1ˆÇÁ‰"œÔ ,~TÍõÐR:ƒIÏ(g bsõØ Çk2 Çƒ3"r5à¾ÍõpÈ×x9س8#ü;œQcœQJ‹Ôʆ;£†—"ÿàŒØ® ×è)֠Ê"˜E׊¬g¤£bx1Eì✱\Qp)…!XáôldE9vFZµ”3\«±Áà Dü3gm‘VD„ê­ŒœI‡ <Îñ+rÞʨ‘S"³ë9£ÐR uÆ»Ú*¦ºX;ã»,½¤“ðy@S<[çË<»ºZ-1)¯SäÅë|¿{½¼‘ó‹|s¹¸ÈvéÇkŠš?~Yð$ôõFR6.ŸÝm“í~¹Ì¶W{J61ç¼lûÿ 3ÿ?©S} o›èö!ä¯oEÇלÏ® æ^WEöÇ>Û,ï“Ûü³«MŠ)U¿½I‹ëŒŒ«qrÖêïRÊVÏê«ÅãZ©äh¦ýíÍê#ÿÈßTÓ.£ä™à¸üÿ•‰ccñ¦F§´eãƒqÅéŒáÁ˜ ÏØ<ÿ„g@©\©`"Õ¤tUæ½­ä¾@r@Ÿ+ ®k¦ÉXIH¤©=$‘y~w¸n^‚yHÏ,Ê_x#Rð#¸¡.üW¿³xJgß“·ôîn}ÿq½Ê÷ŸpmZ¥xjÌõË?Ó´`B˜ÕªL_Ÿ=DتsùõÝMú²>>{ÓsX/ÉßвÅ56¥¸Ð%ÈgÂMõÊ÷[¶º¾Ù•nUŠ<ävoæ É-TYÂüë?äÊIsdb½2-~˜é¿:O#¯I  "P.$p'%R·c²rÚc²i¬¡ ÇiFs:gÈk”:KepUÂOÇØ2Úù˜ûvùû+&»¬dÞÆÄ Œ) Aœ’ÜPöòc¦~ŒáBåT1Ì­…{@Ã#ŒÁ,¸sè‡c#&œ#é0ÖÂOÇô…='1éÄ„ÎBS(Â?&¦VS?Æ0ÕMÄ„A©µ3³ðèŒõ›N„˜Ìé“HL’+°dÀèÇÄÔjê_Í@Õ“á®k5³³ðèÐô›N„˜l(bÊ*¥¥BŠÁ¬JŒ Má§2œÑ­·R½ ì ØÙÉH¤µXç§“HL×F+ew‰©Õ‰˜88wˆ˜œs³ðèŒõ›N„˜Üé“HL`.Ži£Ê[>GÄÔjЬfH¦‰˜ŒîÊÿ9›…Goƒ&b: bâ­KW238ƒ„ŠX¬¹E08bâ,.ÝŠ3+œcˆ©ì¬Ã@KH©´zFbª.Oc8xOÊÒý®ÇÄä7E0ƬMÄ„+!t`ŒÏ£0Öo: bâÿÝBû#Ð ¿­ÄØ¡,0..o˜GL~Sd5ZËCÄätG˜ÍÅ,Pü¶RGÕÜ#&¿©5ãZÖ…=ìZÍä,1µš"–ιCÄ$…긕 µ¢Ý=š~Ó‰S¸ò› +ínËéù’qg’i ?Ñ–[¨çthªÎÆpÁñz˜Xç§Ó`ñ›á<`rÉ•ôIi5E"&QÕþ—“³¦£òEÛ=€±~Ó‰Óéˆß0¸òC-„Å0–µIñšúAC»šÉ&b’–u­fM9·?z4ý¦!¦på7+Ÿ)qxÀÖÉQ©uvåk”¤Ú£Üâm{‚1#ÚÀñœÄ4TüÆXIR‚Ú{ì©Ý‰˜0¯çuÄ$mÆÆX­h·F`¬ßt"Ät:â7 ®üV´yÀ|ÝùuL­¦~Р+ ÝDLäaÐȦœÛ½ šˆé4ˆI†+¿mc¦m§ä؈‰+#©I ¡FFL¼Ü–€9Iû9E;?˜äàmOh7á”Úß(®Õ‰˜8pYO&¤]Ä$›½LüÑë71ÉÓ¿åPñ[ÐÚqt!æ?’ÒjêÆ½Ù HêM­h·F€¦ßt"Ĭü¦'û¥•–c6W½6hðžßä~ÓV…ßq wrdÄ„Ýy©ž”Nb\ùmËÇö™­‡x[M‘ˆ‰iÞì`)è’Œ5åÜþèŒõ›N„˜NGü–CÅo㸣hGø©\«)²Q<8n›ˆICWñ›”³ðèÐô›N„˜‚•ߎ$&@¦Æ¤V16†˜ªMc1ÃôÕ9ÑlÌß( ‘¶k D?ù)Ä4XüvèìÆpAw½ˆÉoŠí`‘h1qÛõ¯lmôÆúM'BL§#~ËÁ•ß pQFÇ×Õã‘÷czÜÔã˜9Ô1‘ÂÒš¦œÛ=š~Ó‰S°òÛZG[<8Ú§{dÄ$ÐMèzè'H.##&쬭ô\‹î9‰i°øÍéék#þôwð›ú?Œ möüÐ)4ж?zcý¦!¦Ó¿åPñ3u%+ô~çÝ•k5õƒÆbúv¸+gD×–²V´[£@Óo:b V~[<`ɧ˜àZ;2bNjnµaBJåÊÎÀÃ3»gMåW~ã©™¥†òéœãÊo¿)ò ¸5pØW{tÜ`‘M9·?zcý¦!¦Ó¿å`ñskÍ1g`ÌßÁ²ÕÔǹMÄdTWU®jmô6h"¦Ó &¬ü¶œÞQ ˜Ñaì¨ÆjL ÀHf§‡JGt†º³Å,£K‡9Ý3“¼í ¦³ÎYC¥ìÖ#&¿)²ø Æt>ö¤š½LüÑë71©Ó¿ÕàÊoªÅ£"™R~å·ß ³>ÜA ]•ߪ)çöG€¦ßt"Ĭü¦÷MiœÞë c¸¥Š˜Œ5Îg­Ü(bª:“fΑ~λrj¨ø­„ì2e…_ùÝjŠÈÊžÇDÚïzP\ÕŠvkôÆúM'BL§#~«¡â7ÝÃ…ðwÆyÄÔjŠ “’™úŽ 8ÖILr=š~Ó‰S°ò›îpª²Ô3²Q©=Ž^¿¤1b¢—¬Œ˜·NkIï²Ñ<ð)Ä4Xü– “$E/“^*×jŠ”¤8®‰˜$˜Ž=¿T£hû£0Öo:b:ñ[ ¿¹ÐB’.©µ—ʵšb·ríáÙ ×èM­h·F€¦ßt"Ĭü6ôzNeË[öãïÊIz©º ½N׌՘dY‰ªÊ÷~ΧÓPñ[ A»åYÚ¤Û«cj5EJR¨.¬‰˜0 íJåjE»5zcý¦!¦Ó¿ÕàmO HMå6¦zþÑ{弦hñ›r‡ˆ©ó…—ªÙËÄ=š~Ó‰S°ò)¥¼-•Õ˜$ív‚Œ&$£5&ì,é%›xÚ=g¹€*~Kür–ž*&ò1µšú?u¨€ wŠ*×µøÕŠvkôÆúM'BL§#~«¡â·VÒ7ô3Ocòš"“àª)q– ºöÊÑl½ šˆé4ˆI+¿)“¢—NEÙXIÒËU —J8fÆjLØY!%izúY5&=Xü¶È± (©õÞ]ØnŠ<öÄœ€CÄdU‡Æ¤EÛ=€±~Ói“>ñ[¿­V€©»µà¿¾©Õ{ÀRÛ&búî¾5GzGv=õc’ø¸ÿ é´]§$Zù€à¾=Ý+š§*‹…¨ †œž€éR´ëìNÑôC7&·ó›cÑít²® —¾Ê˜bÝ´#=k –Ÿ‡QÉ¥ÝG¡øÍ»rí&{[4ƒÐ=€)»ß”HßÀ©HŒº­^Õ˜@H7ÙŒ@.ÚŒ sR®DíØê{À”gÅoÝ&i4Ù°[¨S½4x¡ï§[c*ù±ÆâŸÝ©±~èÀ”ß#~çiñC$ˆùCŒÿ+~×K£Ñ:)_®û&ù>låò¥h×Ù¢é‡nLnç7Êæ¹b_ ©;¿‹Òž×@Vº3á|ØÚ $ÛÜËo¶ äiÛÈ Aë…/íø¦¿K£—_Iׇ™òÃ\¹|y™ÔÙë‡nLï¿ó´ø­/> ÈK¬=¿ë¥ÑhŒ—Wêûa+—/E»ÎîM?t`r;¿Ñn6H†ÃþdÅRé¼+' æÃâjÕÁÒF‹ëûßfñNøü 0͊ߌ` ÕÂg|ÀŸ»rÕÒà®\ÀsÚs3&ôkŒ~üìNõC7¦÷ˆßyVüf6ƒH­âªa„íÒh|3âõ3ê_™žÓ©h7Ù¢é‡nLnç7RDD*ŒdÞ«Œ)ˆn³nŽu'¸ª1)E³–2ål\ÊPÝú`š¿õïf“·²”\±òvi¤1‘\SclbüÓVîT´›ìNõC7¦÷ˆßyÚö„MOŒúÁz®\³4`L9òuW1>ÝcÊ——IÝ)š~è&Àäv~£u7;*ýþ®Ìø0&e¼ÑJC„•#=8F%™T‚pøæ•”<+~“~íõÏIbªÄïfiÐ.`“rNÆJ ŸÓ©h7Ùë‡nLï¿ótç·õ¼² 8R¨¦ziÀ˜löŘðsoÎ)šrµs×ÙÛ¢„îLÅíüFýa %)6ó–ÚÁ2‹îYr8¼œV=¿õaaÂôÝ?î9ÿ`*óßlŽâHHUS³4p°  k¸°p|¦r·sWÙë‡îLå=âw™xi)ÈAwb5cª—Œé<¾=¥§·Y¹§XVÙ¢é‡nLnç7H‘ˆY8c q•1YÛVÈ.¶¬žÊéÃÇ`Ye—á«[¹2+~+kÔRJ6Q¹Ò˜š¥‘ŽÉ·ƒ¥rÊ'ϯr*ÚMv§Æú¡›Ó{Äï2+~ÛÉO±Fþ _þs%¥Z0¦Âpw~›ÂñP4øãgwЦº 0¹ßPÌDC‰+æ @±Ê˜èh÷ É:eWÝI´KÏLäú&0͊ߤ{J;W½nPþw+W/ ÚLp¼<¿R|Ò1Ë©h7Ùë‡nLï¿Ë´ç·u+ÃI±ÚÊ5Kƒ·™¤œnÆ”ÃSÑ\FÞuv§hú¡›“Ûù L ¦©–ˆkWRŒôè¿0ØÒoÌ*cÒgÍ–€Ånñ|˜fÅoÁ`ÔQw¥uKJ»4¿3•Û%5¥§Ër*ÚMv§Æú¡›Ó{Äï2m{RP81؈ÓÚö¤^0&ýÃÞ}ô&¯h./“:»S4ýÐM€ÉíüÂ`'eežÀ‡1EkØ)&2\º’òyXÿu+øMñ»LŠß%p6)?ê.³>ùm–WR ãí+!<Ü•+òãgwj¬º 0½Gü.Óâ·XÌRæ¿'&íÒˆ1•ò˘PÜäR´ëìmÑ B÷&q;¿•)±:aΜ—OåRRlD9§Õ¹réØï"ø;ó€I¦^ÚŒ»¬{¤ µøÝ,õkLÑ>Ó=ížfÊ5ŲÎîÔX?t`’÷ˆß2+~G&} ¥¢ßýʹ]]Pr3¦øäÇ,§¢ÝdwЦº 0¹ß {)°ƒ1ÝÓÅýúØRȇË\d»¸È˜R±F&Éßl°”éÎïl šs‰•ÆÔ, lO¸ä›1Q*OÀtµs×Ùë‡nLï¿eºó;’í70›•k£1ý]ìÿÃÇ-éÓÇ$O[9Á?»S4ýÐM€Éíü¶mg2®§8ÁkÀl˜®RΠ{  Å­Üça{ëçÃQô›“L{~GH¦äGLí%Þji`—’ܳ ‰žXä2ò®³;5ÖݘÞ#~ËtçwÑÚ{?Ç\Ê5Kà –ÿ9•Ó?ñCÑ\íÜuv§hú¡›“Ûùm-’!ˆÂeÁRé`LÇ-» ÁÇ&”cÒ‡‰ÒÚà«“LŠß%(ÙÕ¿]Ê)På’Ú, ¬uYîSJSõLùÇÏîÔX?t`zø-³â·]ÙçÂÖ“'Õ%ÞfiÀ˜lpЭ11>1¦SÑn²;EÓݘÜÎï$ÙæÂi6$«Œ )+œ…Ì\ÖÆ7}ýÎfÑ­dú¦ƒ¥L¼,Q7¥ 6X꯵N»4F®QyƘä©I®)–uv§Æú¡›Ó{Äo™¶=‰ZÃì=Ѷ TKÆ”â/cbz81‰áò2©³7E3 ݘbû§ûxr@D–À6AqÅ÷ØR°[À¥è–,,µ |6í;éÎÆcþÿÀtþyÆ5–ÙzMmÆžäÚ] YŒoÒÀKÏŽ–1\íÜuv§Æú¡[S ¯¿ÏÏ{\4ÅÆ Ùm´Â‘+wfiÀ˜RηçwŽäoåô-þãgwЦº 0¹ßf¯ˆ¨¨BQß«~L1èö˜¹À0}.v%Å®Æ/ŠßçŸg\cY!Òæ”BÌ05Kƒ—N=_çøTc§¢Ýdwj¬º 0½Fü>?ïqÑ›sl®F¬¶rÍÒ€1þ2&Å(ß+'†SÑn²;EÓݘÜÎïDRbÈvVyÞ꩜~û0(ã*6ÅiÕI¦ÍÂJ&”ó¦iñ›m¢‰D“¾ª­\³Ô¯1Û˜_~—¢]gwj¬º 0½Fü>?ïqÑè—ž´”êæºš’Ú. “†Ýî9§'š}y×Ù¢é‡nLnçw¢(v)4&dßñ¯Sà’›a äeË`·Ql›“Œg?ý 0Ív~“¢tL,õPÕv©_c K¿ß,µX~üìNõC7¦×ˆßçç=.­^²›6“ºöün–Œ 1âŘ ¢]@7?~v§hú¡›“Ûùmsá2Úu5‰’–¶rFz +ãZfLúêW8çôÅvóÏ3®±Œ Ÿ… ±áÄÕV®^¸ Äß{ÉŠÙøôò»¦XÖÙë‡nL¯¿ÏÏ{\4Ù®éU,Ú¥c²Ã³‹1Ix&ã©h7ÙÛ¢„îLÑíüNIô ,)—l®À«Œ)…^0 ‡%`ú< Yôqæ/Žo:ÿ<㳎jÛ+aâB5cª—ú5&”äÖ˜t¿ëOI‰1þøÙë‡îLñ=âwœ¿‘²õ-#þÕV®Y0&;⾓x*šSÑn²;EÓݘÜÎïd½ÄŠÎù¸¿Ä˜Ä$56[ÞÃYáôš*šãẠúŸtT݇ÿ˜¦^bd;ð"ÎUS»4`LBùîcRFúÀÊã5ŲÎîÔX?t`zø§mO0£¾Ú3…ú®\½4²=ýÀF8¼øû}L1^^&uv§hú¡›“Ûùm×p9,‘`Y<•SlQ×™ÏÏ “i`:Ö¯ÝâѽÁ7iVü–)sÄ\]{j—÷1ßž_P€ý>¦OE»ÉîÔX?t`zøgÅo¢¨{%æ ¹òÊi—Œ‰á~0¦£¸OE»ÉîM?t`r;¿u/&… ƒ?¯Ì¬<“¡R²‘r\ó"cÊ̒̃ÒÝú`šxQ·`ºÅDÝeþ¦fià`¡…pÕXËíC]S,ëìNõC7¦÷ˆßqÚöÄî G†Ï(ÿjLõÒÈ+'¥kJ …ò0¾I+ëÇÏîM?t`r;¿£I<Ö³‡¨[¹%`RÒÃlÍ•lÔç˜ôTŒ‰õiâ¡°]^ü"0ÍŠßv1Ê!çWŒ©^0&ƒ.Æ$1>´¤ÄSÑn²;5ÖݘÞ#~ÇéÎï ‘’ôëaÍÒ€1eEóg¤@å¡hÒÕÎ]go‹fº0%·ó;Ú¨Ë|Ü>fßX«3D*J Æãj…1).eÝVÛE|›oô=`J³â·è®4æÀ)~6_€©Z0¦„ñê•¥¤:fŠ?~v§Æú¡{Szø¦ÅïDQi,‚µ—UÀT/‡_éQ˜L—¢]gwЦº 0¹ßJóbá`ɉV|S²FÂ\8Ÿ˜–´mN0\JߦÏï„Å.T[¹fiÀ˜ôw»O~=ü¦_#ï¿Ùë‡nLï¿Ó´øm_1h†ÔK#Ædƒ_oÆÄ]¹éR´ëìNÑôC7&·ó[QE”âÙ E™EÏo1—¸`VNTJY¿‡u™Ð` øM`š¿³DI·˜”jñ»Y0&Èr÷ÊE‚3Šv“Ý©±~è&Àôñ;MŠß &¤å¯_#ûTo³ziÀ˜JË]€ÀÉIâ?»S4ýÐM€Éíü65URÈJ÷Ф5ÆT (ý´£ëLi©]ÀV0”¤4J”¡rþ/À4-~ƒ¾Xl:0b¨âê¥ÑˆpοӞ?/B¯Æ.E»ÎîÔX?t`zø¦^ýê3¾ç\Ý•k–FŒ©äßS9|rH×Ë:»S4ýÐM€ÉíüÖ­gaº iñ®œd¶~ÐÏÌzñT.ÇhÛÔgá›§riVü.‚J¯ ÐÑÇþ·©^0&Šr÷ÊA’§;í&»ScýÐM€é=âwš¿³½š¿ÚÐ׺hꥑÆ$¿–òd!üøÙÛ¢„îLàv~+4$3‘†˜írÉjç·jfk_xy<Íü²èËß쫾×ù Ó¶'¨À¢Ûûü¹ð_Û“ziÀ˜8Ý:&RHípy™ÔÙë‡îLðñ&Åo3{PöÊlþXUÑ4K#Æ”ãý6+!?œ˜@úñ³;EÓݘÜÎoeLI™‹µÆP¦Õ¹rÁ¼RЦήx¦|îÊEÔ=5°q5¢Ú¿Ó´í Ã1½3ÕFqÍÒhÚs¸O~‘áIc‚ËˤÎîÔX?t`zø ³âwÒ*Ö¼pí`Ù, OåR¸Þfèémv*ÚMv§hú¡›“Ûù™lˆ‡2=ݘ­3&ÝS ÉŸ:%%ØØbfJøU£8˜·=1ÅKts›«1ôíÒ€1eLñª1’§—ßíeRewj¬º 0½Gü†ÙÎï¤Ö}µ~rÕùÝ, û˜ðž’rLò‹ælçn²;EÓݘÜÎïÈJô'’"®:Xêï®_Å5¥\+†áÆdW€uÿ i¼‰ü`š¶=ÉQ8)q4›î¿ÀÔ,“üNâ9¯Ûz5vy™ÔÙë‡nLï¿aÚö¤XqƬ/ØÚö¤^1¦œïý??ô1ÁåeRgwЦº 0ùߤ`šHÑ%­žÏ©\)dB(†­Hõ©œós A_ýãû,ÿLÓžßB¤o-ëB«S³4`Lðöü²5vy×Ùë‡nLï¿a¶ó›l¦ª}  êcj–Ƨrt¿ÍR|ØÊáÙÎÝdo‹fº0¡ßùmó«˜JAë_u "º³ ”õS]<•#‰ºçŤÈÄ_íüÆé—Ñ& Ò1—áïV®^0¦œï OWRðšbYgwj¬º0á{Äoœïüæ­_žP]h—F}Lï®Üs§îÍÝÎ]ewЦº 0ùßvGÎ~‰l—ü,•ƤÜÓì†`àÕ>&;x¤Ô"ˆÈ°mü_€izàe ±Ÿ ƺÁ²^1¦ ¿Óç5åÕØ5ŲÎîÔX?t`zøÓ/³y'ÒGãÇT/ SÑ-Èõ6Ë!?låðšbYgwЦº 0ùß AwcB;HZcLƒÉ°Œú)â*c‚˜"éNΚο LÓßùØ›ŠiòÍ$ÞjiĘoVN,§rxµs×Ùë‡nLï¿qVüŽŠ&#gª…ÉviÀ˜áž+—áÉóOE»ÉîM?t`ò;¿Á&Zq6kª5Æ)'3ÈÕï!-2&ÛÚyÅ·¯2¦…—6Î;ë5Õ'¿õÒ€1™…å͘ғƒ%þN±ü›Ý©±~è&ÀôñgÅo±&ÿ¤ e²Õ©\³4`LÒï\9» áÍ©h7Ù¢é‡nL~ç7ØÉZÎhM+3+Æ3˜“‚æNúYdLÑìôÅœ ¾zWgÅoe#(‰“Í“ cú»4`LBxß.PVøp*‡òãgwj¬º 0½GüÆYñ[ÿëWm#Vm嚥þÛ BJ¿Œ‰é1Qøñ³·E3ݘÈïüNY¡9([ÂÓª»@ú !ëYdLöÝÒ·)|˜hºó;|”|Ôÿú˘ڥ+7kΛ1Åð cÒÕÎ]gwj¬º0Ñ{Äoš¿A_Hvs1W–íRÿmåú˜ž†Ò©h7Ù¢é‡nL~çwR¾¤@J—–.ñ*é P¨p v:·È˜BAJ!+i£!ªý 0MŠßÅ6)ùËùÓDòß—_½4`åÓ/c’ð 1üøÙë‡nLï¿iVüfÈ.YôÏ’ÿM³4bLúe¸ßfœÄoÂ?»S4ýÐM€Éïü¶ ä¤{мê. _¿d^¯¨àBKÖºÇà³0Kéý 0͊ߨŒ7I ¬,²2Šk–FŒ©ðï©\Lt*ÚMv§Æú¡›Ó{Äoš¿Q÷ ‹˜åd3%¥Z0¦üŸ»rå¡ùNE»ÉîM?t`ò;¿£c°~=;€^œ+Wr9&Ô”ì%¾Æ˜Ì„‹ÂSQ@ÿ&0ÍŠßæ¢¤? ÚÛªW®Y1¦òÆ”Êc:í&»ScýÐM€é=â7MÛž˜ók”˜l®Çߢi–Œ)Æs+wœÊÉÓÛìò2©³;EÓݘüÎo»©J\½g‘1)§l· ×V;¿õaý碵œ+°}³ó›¦;¿m2 ¢"5”êo³4`LúDº=M⥫»ÎîÔX?t`zøM â·nÕs( +­øýwiĘî›ßfÁè ÿ*Ú³·E3ݘØïüÖ Õ炘¨ºÈ˜J2ÙÛ¹›ìNõC7¦÷ˆß<ÝùìfU´ág¡ºÄÛ, Sú˜ÃŒ Žrùj箳;EÓݘÜÎo¡lBmHÀîÑLcËÁ˜l?¡¸¤»9‚µ—ÇÃÊ%¢9 qÆo#àé—!Òýåß–viĘ˜àà _S,ëìNõC7¦÷ˆß<+~ë–Ë&QùÏ•0Ù, Súœ’|ÓG òŠæT´›ìNÑôC7&·ó[1b„Lº3X9ñ?“E±_ÚN׃ä \‹"ÀøHï_€iÖö$aV®[@ ×Ú¥c‚„¿}LŸ£¯ÆN/“&»ScýÐM€é=â7ÏŠßA7×6c('ª] Y0&ÐíÖõ6+ž¶r§¢ÝdwЦº 0¹ßå8­4å>ÈBäÁ˜(rà$9)K,KWR>g²ë¿%óJ ϊߺ¯T‡6a¯:ùm—Œ ÿú1az8•ãSÑn²;5ÖݘÞ#~ó¬ø­_vÝ)Å9sø LÍÒ€1†›1•˜Š&ŸŠv“½-šAèÀ”ÝÎïBÁÜíEþ‹Œ)%ÒÝÛhtÝd,2&ÓaR.º5É¿ Lyºó›§A°èUw~×K#Æ~,)ä‡&Þ|µs×Ùë‡îLù=âwž¿£hçÃ5¨*šviÀ˜òÝù­ᇠ–9ýøÙ¢é‡nLnçwÁ$6ŽØ,[ÃÊh¸ƒ1¥l6”ÇÀª²¬1%3=µ"ñ«#Âó¬ømc•O‹DÆÚ©^1&¢»ÆèsiÜ«±SÑn²;5ÖݘÞ#~çYñûà°ËðÕ%ÞfiÀ˜Â}ó»d|z›Šv“Ý)š~è&Àäv~»¬žEu‡—€IŽÁºŸL 2¯×EÆÍ+ èÃ,ß¼+—§=¿1ëOÃúSUßÍÒˆ1ñï}L›ÖðPc—‘wÝ©±~è&Àôñ;ϊߦ܈M¹*Û“fiÀ˜(¥»I¸<Ó©h7Ù¢é‡nLnç·þ¬6_H™‹P.2&óÙ³N¦¢»±¥+)ÇÃŠŠ †J2ྠL³â·pBÖ]˜`µ•k–ŒIYùï©Üã•”|*ÚMv§Æú¡›Ó{Äï<+~£Í‹%‰FdkËziĘï“£1Ð/šSÑn²;EÓݘÜÎïb}Dv•ÆÖò’ømS hNq). Tp> ¥CAo¶ äé—º¯ÕW•‘‘fva½4`Lþãùñ©ÆäÇÏîÔX?t`zø§=¿É,`A_1Wâw³4Ò˜>·½?§r”4¦ry×ÙÛ¢„îLÅíü.Š¡ÁF™ÈTôëƒ1A4ƒÜ"‰V'ñÚÃ6 ¥”˜†\퀩̊ß9¦ÀÈÔüêJJ³4`Láî•ãðtò[NE»ÉîÔX?t`*ï¿Ëtç7ý£˜·Õâw³4`LTøfLúöyèÊ-W;wÝ)š~è&Àäv~Ûý>¥J`]{eì¼]1&R‚h˜À<0Wû˜ôa;¾D‰à›WRÊ´ç·$¥»v·˜*kviĘ$üÞ•ËO#ÂËeä]gwj¬º 0½Gü.³â·n¹ôõ)¢þë/05K# ó=Á¢pzèü.§¢ÝdwЦº 0¹ß%šWžÙXêtŶûÓÇdàE_ßå3ûi©‰‚~¹t+rHßÜÊ•Yñ›íà""GýDêK¼õÒ€1i%üº¤J~Иʩh7Ùë‡nLï¿ËôÀK ;< A_ÏUçw³4`LçÔŠc²yh~Ñ\S,ëìNÑôC7&·ó;‹îÁt?ec¾a¹ó[±…ìÝ]ŒW§¤¨Ê•lnñøð¿Ó¬øúgCý/ õ˯]0&fºkLq÷‰1Šv“Ý©±~è&Àôñ»LÛž¤hÇi¥´žßÍÒ€1qþõÊƧ¢¹¼LêìNÑôC7&·óû$•硵«¯1&ýzÒœ}Ë}Lú°Bš•"}³] L{~'sùåã  :•k–FŒ)ÿçTŽŸ&ñ”ËÈ»ÎîÔX?t`zø]fÅo°Û ÖZf‡jÕV®^1¦îy¼. §¢Ýdo‹fº0‰ÛùQlæ”D‘ó‘Š1!Æ”$Ú¶¬éÁõ0sa–™#½&™¶=)lÃî"ÙÈóŠ1ÕK£iÏ1þÞ•ËOíry™ÔÙë‡îLòñ[¦Åo}·s æóV‰ßõÒ€1e¦tþŒ&ɧrr*ÚMv§Æú¡›Ó{Äo™¿í žôïaÓÛ+ÆT/“ÄûS‘ôp*'—¢]gwЦº 0¹ßfºMAB&ÃèÕÎo6L±Ž‹¨¼iÙ] FSJì¶[;ÿ˜fÅo¥ºbŠ“€ÍIY¹hçÃPôK+ÊWû˜dVüÖ÷I`0‡¨*ÆÔ,SηŽÉ¯I¯ÆNE»ÉîÔX?t`zø-ÓâwfY«{ë+kÝfiÀ˜Ì3ñ|›Ù„§¢¹í:»S4ýÐM€ÉíüfR²ƒ‘‹ASXj°4™H šÁœ9É.;X¢=Ìæ2 _íc’iÛ±ðÐ^1©Y1&ÀÿjLOrÁåeRgwj¬º 0½Gü–iÏo‚d·ØsÆTm嚥c²Ë͘ÊÃÀK%Ì?~ö¦hF¡[Sjÿtc2¦Ħ0Å•ënŸ>&ù’ràÌË~LF]‹—Ã8ž–ùÿ¦óÏ3QcAÿpÑp:ÔM¼õÒ€1•;¿Eü–âŸÝ©±~èÀ”ÂkÄïóóž(&LÖ'Ò_šÝ.ÓGð>Oå²ÿ6K!ýøÙ¢é‡nLnç7i=Œíìªßê©)ª)9d¾VOåôa}œ°èr,»ÿ 0Mw~s±SJ»Ÿ#õ•”ziÀ˜ôc¹Sþ¸s{5vµs×Ùë‡nL¯¿ÏÏ{\4vu‚‚° o¯.X¶KCÆ$×þŸÂÇ<Â+šSÑn²;EÓݘÜÎoÒ=œ~ìÚú ¶|JÉQÅ`ïïEÆ„Bº‹;|ûǽÿL“â·nÅ©0G»KÙŒ«—ŒI2ß· ôQ_.H~üìNõC7¦×ˆßçç=Q4Ÿ³x²ÿ!05K#Ư·Yᇣ\ý²üøÙ¢é‡nLnç·Ò–DJxHrâe?&J‚úÑ…µñMŸ‡õŸ­_àhTߦiñ[‘"HŸ#‘?—x«¥Ñ´ç~Oå >±òKÑ®³;5Öݘ^#~ŸŸ÷¸h Úùs"ÆTOâ­—FŒ n?&²ÑvEsy™ÔÙ¢é‡nLnç·r–l5ÎQ”H®:XêL;+ÁÚ.O匬ÙÔíÉW·r“âwT„N$v¦V·¤ÔKƒ ~gæàÅ¥ ?~v§Æú¡›ÓkÄïóóMÎ"vË´¤˜CÕcÒ,Æ[c*4;†?{[4ƒÐ=€)ºßd®ù Ûƒ¬¿F^ØŒ)3š™’2Äãðz1éÃÖ+h3Òx¬ný0ÅÙÎoÊHÄ.q}*W/&ñp¹jŒBÁVÏvî&»ScýÐ=€)¾Gü޳â·ÓˆÖ(¬›êĤYu~çÿLâŇÎïÓŸÝ)š~è&Àäv~“éCAlº‹nC—€Éš·Y”*鱦¤åÎo…#»(@€ßdLqÚóÛ\—usoW±«­\³4š]Hùr ݰ>ÕØeä]gwj¬º 0½GüŽ /%3H*`j–o³ÃbúÚÿ‡?¦§XþÍîM?t`r;¿ÊÈ%‚Ùo¯ÈDŸ))Ê–ˆƒ}R^°:%Eßûú¥Í6ľh{rþyÆ5–¡h50 è׿j°l–FŒ©ÄË]@LJ>¦Ïvî&»ScýÐM€é=âwœ·=QB’͆½jh–Fß™¯ŸK|&ãíeRewЦº 0¹ßHIwŸ&~#XK×cÊ‚úÛPl"»¨ºÄ˜ôáX¢5}+¹øªø'Åo‰™»T5í¹Y1&%ÏW‰¢ÿCå?»ScýÐM€é=âwœx”ø›¡(ÄÆÁ²^1& ÿ™’žÓ5ŲÎîM?t`r;¿æFkÀ²aßË~LA0…–,‡‰DKá¯2¦yÏoý²ÄTîÍÒÈW>Þ“x(=´¤ÄÛÈ»ÊîÔX?t`zøgÅo}§ë–£ õVã››¥‘ÆèÖ˜è±Á2Šv“½-šAèÀ”ÜÎoT–—ìÒ10MtUSlŽïaÍ»´•;Ž6ÓC֯ا¤œž‰˘tWjÿY¡o—F.©±ÜS¢ò ~§ËÈ»ÎîÔX?t`Jï¿Ó¤ø‹”%L¥FX/Ü”_Œ Sx Ù)ýøÙ¢é‡nLnç·2¥Ì×Nô5V=¿Ê ›71Žõëš1)ŒÛ¶ÃØ—÷_€iVü&Žº·‡¬ÉêÚS»4¬±pMI!È)Šv“Ý©±~è&Àôñ;ÍŠßbwÑ™“rÙÊ’¢]½ÍH.?&›}ùpW.Šv“Ý)š~è&Àäv~ë&,e>Æ„Û,¦E‰B(YÀîÛEZjø³¨Ó¡©[¾ÚùfÅoÔO EYsûÿ LÍÒhãí`?Ü•K§¢Ýdwj¬º 0½GüNÓ/YbbJ µQ\½4Ò˜Pî>&ŠñaÿŸ®)–uv§hú¡›“Ûù `[ÝLåÀÓÝþî)‚y)˜Ç¬YëÚÊfœC°†o¼<ÿ<ãË  ¿’M+¥R1¦fi¤1e†‹1ú›_cg;w“Ý©±~è&Àôñ;MÛžHf›cmêS¹zi¤1Åß))ˆOÂdº¼LêìNÑôC7&·ó;É1òRì¨r©yû`LúA*ãótʼ°„Ïãùƒ@ŠøÅaçŸg\cºMʺ·,ëK¼ÍÒˆ1åüëùEO÷1ÓåeRgwj¬º 0½GüNÓ/Í#ãx U4»]2¦ü«1}¦s9E×Ë:{[4ƒÐ=€ ÜÎïtÈeB…¥0 ð·h¸Í‚ ß–”Oåôa å0Ù\™/ÌŠß‚¨LD7J’¨Ò1›¥AÐï}Lyj°„øãgwj¬º0Á{Äo˜íüNTŠò«`º_Õ.Ð,Sù’b_ȇ¢9Û¹›ìNÑôC7&·ó;aŽtðž$06¸ý˘X]}¨Ý[Øo¼Ä˜ØFð&…ò`ÞEßÜÊÁ´ø²ý(Šnm«Îïfi¨1åß>&~’ àR´ëìNõC7¦÷ˆß0íùM…3‡’¸ßÔ,îÊE¾=¿­Ãò¡h.#ï:»S4ýÐM€ÉíüNIIR2W„°²;SŽhÎ% fb¹Øù­^qú]ûªÆÓ¶'’ s‚b£Kk¹ ZiL/ K)O¬üò2©³;5ÖݘÞ#~ôø­_P'Ö\Ê5KC)ðõ6ƒÓ€W4—¢]gwЦº 0¹ßIK\_-÷UÆ$º¯€¨FÎ%5c²òI$ÝË}³Áf;¿Í"!0Æ ÔÔX½4š]3^S ðÐÇg;w“Ý©±~è&ÀôñfÅoÈ™€É.²K}‰·^¼Í(ã=%5êVæ¡hNE»ÉîM?t`r;¿SkãKK£á>ý8£¢L^eLŨ«°M~šãû/À4+~#‘Ö\U;X4KÃÙ…pÝǤÈ“xœŠv“Ý©±~è&Àôñ¦^r²3íDTÝcj–Fo3¸{L0–ò°•ÃkŠe½-šAèÀ„nç·un‡Bv'4Š~}0&ý})ÚEhý}ó⩳b"³ù™ óE`ÂYÏŇp¨òÕV®^Õ˜Ù^§røtÀ‚§‘w“Ý©±~èÀ„ï¿q¶ó;£ÍfÔ=Cªiv»4bL—Qœ2¦€øÀ˜0ýøÙ¢é‡nLnçwЇ¢ùÏ¢¾æ“”(I‰™íts1‰n}m”ÌŒñ‹À4=ð2Ù8b“¾ jIi—†ž_r÷1Aâ'`º¦XÖÙë‡nLï¿qÚó;DA¥È©š’Ú. Þf§)©ýŒvQìáT/#ï:»S4ýÐM€ÉíüN‘s !—B”ÇCª>¦`SŠ"‰©ýkÃއ£˜ÙŠ µÃojL8m{¢t÷ømrmßÜ.,$ÝÓžðÁÁ//“:»ScýÐM€é=â7ΊßQ7 Œ%cjæÊ5K£“¯ý¿ù”“xµs×Ù¢é‡nL~çwJJñtÿi—æÖŒâ”ô${ÜF^ðÊ_ø<ØFG•8ƒð/À4ÝùMJEr挥jh—Ƴ ¯¹ržÓÕÎ]gwj¬º 0½GüÆéÎoÀ‚ÌŒñÓùßÎïziä.˜ï)©Àð4ð’®vî:{[4ƒÐ=€‰üÎ樂Åj`<·fLbÔº%ËB+ûÀcPW 6¼ñ‹ÀDÓ¶'Åî‹îl?JÿÕ1륡çW¼Ýâ§«Í«±ËˤÎîÔX?t`¢÷ˆß4=ð2ˆ(¨$}cTÀT/“ðÕù­Àôd{J×Ë:»S4ýÐM€ÉïüNP‚îãÐðÕ»r¶¡ ¡uïºÊ˜¢’-$ÈúÊîÿL“â·5Þ¦\ Û¤›\ÉõÒ¨Wîn§rñiàÁŸÝ©±~è&Àôñ›¦Åï$Ö H˜J=Z§Y1&”ëTˆâSÑ\ŠvÝ)š~è&Àäw~Û8 Ý„l¾'K—x•ôè¾UŸNÖ –Vû˜ôabˆ¥ØñÒXÝú`š¿s*ºgýÁrªâꥑÆéž’SxbL§¢Ýdwj¬º 0½Gü¦YñÛºŒå°£ÁR3¦ziĘÞŒ ?Û:¯høÇÏîM?t`zèü6­žm\ eZº’b–Jǹؘ•UÏoÔoE}1„Ê7Åoš¿‘)‹)ð_ÆÔ.¦‹1¡|nNz5v*ÚMv§Æú¡›Ó{Äošîü&AèA¿©Y1&¹;¿uŸþä.HW;wÝ)š~è&Àäw~'Ý€‚I‘ì%¿èÇ„¨Ÿ¦(ç±ÞñU?&³b ÝKFå\Çÿ˜¦=¿mDÌÂL•çW»4êüÎé×]ó“Žyy×Ùë‡nLï¿iVüÖ­‚ج?»ýPoåê¥á ¼zLËÓVŽÃŸ½-šAèÀÄ~ç7°²»u+–a|hß0&3¯´_:Ëx˜nØb@F›Nž¿y%…§mO@ì€rÉ•ÆÔ.:¿n—Ô‚O¬œ//“:»ScýÐ=€‰ß#~ó¬øM6ÐDÿ hÿó/05Kƒ·Y¾Þf`÷µŠæT´›ìNÑôC7&¿óÙîë͹{UcÒÇõ÷Õ ¹âÚê©&sûL sšhTø`šíüÖˆÙ.Ö/›¥á]¹pß.PÐ5v¶s7Ùë‡nLï¿yVü6ïz¤ÿ]ª­\³4êü|Ýü…’‡»r|*ÚMv§hú¡›“ßùœì6™nÅXâjS ó¶*`3«Â¢»€>Ì@l”‹Âÿ˜æ^’µ-2ëÖ²jh–F~Lå¾+‡ô8T•ï)–Uv§Æú¡›Ó{Äož¿E¿øÇå Ý+Uâw½4êüþÜËþhL’î1ñ¥h×Ù¢é‡nL~ç7´ƒ­ø(qñTŽÍwš³™ó#±W,³~\Qÿ/3}óJ O{~å}ÀAÑ2UÖºÍÒÈÁ’ðfLJ 4&¾Œ¼ëìNõC7¦÷ˆß<-~£*ÙÑ}C-~×K£)))_'&ÀÈ'&|)Úuv§hú¡›“ßù­Ÿ@PÎbó]p<¨»r$}u+¶%…¨EIFýœ@‚nå«[¹iñ›…³îÂ>Æ8G„ý]±r‚Ûó+eyèüæKÑ®³;5ÖݘÞ#~ótç·¾øÈôŒL©º+×,Ü^=&ʘžFëä«»ÎÞÍ t`ÊßÑ,ˆƒYæ·ëÎï )¦€Qìïjçw°}` #Žç‹ÿ0åYñb(ºAýÒ×§rÍÒˆ1}îþŒ)é~ù¡ÆNE»ÉîÔX?t`Êï¿ó¬ø]"š)u°)CÕ©\³4:1ùÌ—8SŽOsåò©h7Ù¢é‡nLnçw°aYiuJ g².ýŽÄl©S&.‰l|“ê}˜&Åo›?¢dWÿ õìÂviPc±ÈíùBy8•ËE»ÍîÔX?t`zøgÅ™ÜصÑR1¦fið6SŠpÏ• Äï|*ÚMv§hú¡›“Ûù©P.¬ÿZu°„J±Q(.ЭCcÒW¾“~fá›[¹<+~³î¿"#°$®çÊÕKýK’ó}» Z!½;í&»ScýÐM€é=âwž¿1±Ò+ýòKUçw³Ô›aLåºù‘žNLò©h7Ù¢é‡nLnçw¼6(\Ái±‰‘mgQXÓŠ5|¶¦oëf‚T¾Ê˜f=¿íGA¢Âöký­±f©_cI$Ý'¿úñ<è˜ù4òn²;5ÖݘÞ#~çIñ[ß®ú†¥"þëùÝ.õßfä~›a Ožß¹üøÙ¢é‡nLnçwLúS£î5”ãñÊ<Óó2$»‘BºÃXöüN(ÅüœX÷“ߦIñÛˆ›ÝÄ>ºá+_ùfiÔ+GòëùÅáéå'?~v§Æú¡›Ó{Äï<)~çbºôÿ•æJJ»4tŒ÷©\ÉOŒ©„?{[4ƒÐ=€©¸ß6Ð<‘ÌËså2š€“ì\ÍÌV;¿ƒ™Ôé§•Á7Åï2ëùm3š“Œ¹’ š¥Ñ©œ”»ó;ÆÇ‹?~v§Æú¡{Syø]fÅïXˆ”¼êÛ=çªó»Yuå’Ü}LœžöÿåT´›ìNÑôC7&·ó;š½¢B’î©‚Œ§»U§rå ;h{pÅ3>ë–8ØgöM`šíüf;r‚J.h—F'¿TîI<©àÃK9Û¹›ìNõC7¦÷ˆßeVüf*ÙA&ªf~5K£S9Š×Ï$ðô6;í&»S4ýÐM€Éíü6S1}­‡¼ØÇ”‹âšnZX×Äïãá¨{Þ“þÓÇçÿLÓâ7–"º· •\Ð,;¿'ñ0>4ñ–KÑ®³;5ÖݘÞ#~—é—E߬b;† õ0Âziä.÷$^³o|8•+×Ë:»S4ýÐM€ÉíüŽÑú|GÝß&\ôü.æ–Â,ÉîáÒÒ0{X¿\%#[4õ/À4Ûù­F%r°]mŘš¥cJùbå6"ìAÇ,g;w“Ý©±~è&Àôñ»Lw~‹5ªQˆ˜bÝù]/¼r®vÞâ©ù­\íÜuv§hú¡›“Ûù-¨`ªˆ”2+:¶<üA}ÆÄ`£—¢,^I9Ž’—ô³bþæ•”2ÝùMöãý+†Py~7K#Æ„pû1zºY®vî:»ScýÐM€é=âw™íüF )Ù<”P ¼l–FŒ)Ó5óË®¤<4¿ÉÙÎÝdo‹fº0‰ÛùC`(À\Ž!JÓÀd2‘HPâCv7plåäR´ëìNõC7¦÷ˆß2íùmÆ}¢ì‘+`j–F~Ìå×)ybL—‘wÝ)š~è&ÀôÐù­$/†@†Q«Œ)'±ÑŽú‘¦´Øù­›QlÖ׿ùÅ~˜¦Åï“¡ˆ £ªÝê¥!cŠ·Kª”'Ïo¹í:»ScýÐM€é=â·ÌŠßöV%gýϘš¥áÌ/¸=¿óçB¯W4üãgwЦº 0¹â·n¦”è¡ò<ý$ŠÁ.0¦œ£mâ”w*«}L9›ÄHÍÆò›“ÌŠßZ AéŸuWcÅ˜š¥¡Æ„÷´gÁôL§¢Ýdwj¬º 0½Gü–Yñ;€îŠD}­×}LÍÒ¨ó;ÜûÓ›Äo9í&»S4ýÐM€É·=ɺ±¥Â‚!†D‹Œ)‡Ì!0'ÓQÖSJ– QÔ=pþæ0™¿•ùéO£5ÁHÕ]¹fiȘøîü–Äí"?~v§Æú¡›Ó{Äo™¿Íå8è ™k`j–wå‡ßÎï >c‚p*ÚMö¦hF¡[´:+ýEsE2‹a:n¬­hLXl2LЍX<žYYw~—ÌYÌwt{ò=`:ÿ<5ì%ÛÎêJJ³4êü.¿ž_%¿‰ÂÙÎÝdwj¬º0Axø}~ÞEÃ*œ0q¬¼rÚ¥cŠtïÿ3fÿÄÂ5ŲÎîM?t`rÅo6_QΣ[±’x‘1éE’¤ v<¾xWNb&±)D–/^â=ÿ<㳑Kº­dÝ[†T1¦fiĘb¸YyùÔ›Wc§¢Ýdwj¬º 0½Fü>?ïqÑØxûRtç`‡ÌU»@³4rÈáÖ˜JŽþuøãgwЦº 0¹âwN!۠ά”).2¦TÄODì.ï*cÒ‡CITìToÜù/À4+~@3†Ô=åÚÁ²^žÊÝ–ÊÊkìT´›ìNõC7¦×ˆßçç=.;˜†T‚M8-•Q\³4`LÖ­|¿Íž‹æT´›ìNÑôC7&×ö$“ P¡"„yYc B¤Û13ìä•¡tKA¦›_EÆ/ú1žqéæÍ‚Ô.ïÅjA³4bL·KªYÀ?ÔØ5ŲÎîÔX?t`zø}~Þã¢)æ ÀÖôªÔ¿º’Ò, SÂpÝcÒGù‰f_íÜuv§hú¡›“k{’AlVe -Ê™ÖRš•MT‹´bMçÃA·q™uC8¾ ó/À4k{‰LÒ¿_©‡ª6K#ÆÊÝ+—?þ_^^&Mv§Æú¡›ÓkÄïóóž(Acþ¤ï‰X3¦fiĘrþeL)ø§rOE»ÉÞÍ t`Š®í ë+ØÆsêÿ !.‰ßáY± 2Òýk^ícÒ‡C&Èló®á‹}LçŸg\c¹ØfUßÍÒˆ1¸OåXø˜âÙÎÝdwj¬º0Å÷ˆßqVü>N»¬ŸUS³4`Läv°´{mEs*ÚMv§hú¡›“k{bÃlRɉ—®¤(ªQ::+ƒÝáKâ÷çaÀ˜bЭuþ¦ø'Åo»ƒfFÁTÌɼbLõÒˆ1A¾j ô1¿]"üøÙë‡nLï¿ã¬øm‚„¾%©ñcj–Œ)•ô˘ʃ» Düñ³;EÓݘ\Ûýqs(ú¶ƒÄîm…1ò¥Âº+WÝìá ÿ%ú-þ¢QÜùç×X¶žýìs‰·YjLá÷>fŽO/¿»»ÊîÔX?t`zøçmOô@Àj+×,Sß øø6»½LªìNÑôC7&·óYw³v\¯›»±Æ˜ëP”1b\<•³‡SÁ¬ÿ1ÛÆÿ˜fÅï¬?@K5ð¢]1&á»Iñ÷éåw*ÚMv§Æú¡›Ó{Äï8+~êŸW«Øl·Â_`j–Œ óõ6“OÓ©h7Ù¢é‡nLnç7dF ¦Xt‡ËKÀ¤¤'FJJ¹¤ˆaZdL1¢”¨ÜÂüb¾ª1Ív~3™±‹RÈRÊ5KãÙ…w±< U…x¶s7Ùë‡nLï¿ã¬øbÉÌYKLÍÒ€1éöåWc¢?&H§¢Ýdo‹fº0%·ó;•¬Û1»R¢°Zû˜8(“âZ Ö,?‡ QÿDß´Ö=ÿ<ãS€E»|›“õXý¦fi4í™â}ò›£„‡;í&»ScýÐ=€)½GüNÓ¶')êK"åB\S³4bL\îý¿”‡Ñ:./“:»S4ýÐM€ÉíüNúG²&I3’ZeLºcÕ=K€Œ)­Ì~‚óaÐw¿õ }³] Ív~›9‹MáüÜtû05K#_ù}ú˜NåÒÙÎÝdwj¬º 0½GüN“âwΤìU¢b rõ6k–FŒ‰øú1|¼™¼¢Á?»S4ýÐM€É·=Ñ-‡n;X·d”Ãâ]9•\Ønõˆ,Í~‚ëáÌÆÃÁ¿ L³â·¢l)!êÅ9VÀT/\Rñ?÷1ùI.H§¢Ýdwj¬º 0½GüNÓ/uà ! qÿªù­Y1¦Ì¿^9„O4ûšbYgwЦº 0¹ßJy‚ÁƒMœ‚£ÿzÚö$ü/IúÛK´Îñ5Û“óá¤Ä"²bâÝÎ?ϸÆ23rúV¡OÉ£¸jiä’ÊÝù]=\âMùÇÏîÔX?t`zøfÅï”t§dïuN±:•k–FŒ ù×]Pžn~§SÑn²;EÓݘ\ñ›YÉŽÍ !Ç£‰æ“ùé"´>Õ¥­ÜçaJö¤É_eLÓžß`'…¤¬—ê))ÍÒ1É]cZ§ré2ò®³;5ÖݘÞ#~§Yñ;&a…‘ Lõ””fiÀ˜(ÒÝǤÞ‡{L~üìmÑ B÷&pÅo)úaÝ–™²È˜r6ÓýÖIÒ¢»€=¬ÿ—Íp<Ã75&˜¿­£ë¸&Sjûæviä’Špë˜EžXàT´›ìNõC÷&xø ³â7dÛ1(ç7sê¿ÀÔ, û˜ò¯»àcç7œŠv“Ý)š~è&ÀäŠß±e.¤âRƒ¥’1³2,aÑÁÒ¶9¾­ù뛌 fÅïbsÒÍÝ:*ÆT/|å‰ðfLž^~§¢Ýdwj¬º 0½Gü†ÙÎoâö6ŒXù15K#INaò°Ù}0Š8Û¹›ìNÑôC7&Wü†@ºë°A c^ôcÒMóÕM…ÓX¿®“î£nåB@›,ûM`š¿K4£_%;vé±¾’R/¥»ÆìÆÏCÑŸÝ©±~è&ÀôñfÅo¥!Á¦ISÉ¡òün–FŒé¿o3¢'`:í&»S4ýÐM€éAü6'`Ræ’ áâ\9RH³a'Å WÝôaЬ|-k’¯^â…iñ;èN\QÄF¢6㛪¥c*òÏ/xbå—¢]gwj¬º 0½Gü†Yñ; sÎ)Ö¢ÕÛ¬^iL’;¿9=ÑìSÑn²;EÓݘ\ÛÝK™“aƵ—Jzìˆ(¡9—eët^cL̰$Ô]¤”ožÊÁtç·$ÝÚê«¥båíÒ€1™ßð͘J|Ò˜®vî:»ScýÐM€é=â7L¼LI_¯¦á¤úJJ³4:•“ðŸ áÁZ¯)–uö¶h¡{º¶'…J¤cJú3çÅ>&Êð¹-g¶hcýº>•ˆbc‘A!ý›—xqZü¶–_ÊÖŽV‰ßõÒhÏç\ödå//E»ÎîÔX?t`Â÷ˆß8-~CÂb7«u—]‹ßõÒ€1q’_‰ž® à¥h×Ù¢é‡nL®í‰Ø¨J4ZÁ!-Nâ¥R81˜Wq eqJŠ=lnŸ³ââ7·r8+~K Å6µš+)ÕÒˆ1QüÕ˜”G?ÔüøÙë‡nLï¿qzà%$’"Ù_ë>¦ziĘÊ}Wäi®à5ŲÎîM?t`rmO¢9"†h£J\±í>ïÊYÙ.žÊÙ3 íš|—1Ív~[v)6]A*³]Mâ¡ÛÁBY9=½üÎvî&»ScýÐM€é=â7ΊßÑÞ|,9×ÀÔ,Ÿ[¹Oç÷ÃþOE»ÉîM?t`rmǪ’Á “Y¡/“]w»¢¿±)‹w倣B¢†°Ë‹_¦Yñ;±AlŒÖ[]Ý•k–F“x.`:¶uOâ7žŠv“Ý©±~è&Àôñ§Åï¤û…\¢îª¢i—o3}ë\'&ÂÃ0BÀKÑ®³;EÓݘÜÎoeI&.A²É®²Ð¼}hL¦sdÒßû`k“Ó›ì ³àWâpVü–¤ðš­UR5‰·Y1¦„¿SR2<œüâ©h7Ùë‡nLï¿qzàe°h1ŠÍŒ­4¦ziĘþ;WþÓ¦æ ]S,ëìmÑ B÷&r;¿c²1Ýú3Ý–­x½“DSû)R2G§EI¢BØ"ø¦QÍŠßr–BljÈ_ûæviä+}Æ„WRèT´›ìNõC÷&zøMÓ¶'d†÷6£pµ•k–FŒ)Ç«IÓ“ÆD——IÝ)š~è&Àäw~'0Úc·Ö@÷‹ŒI·`‰ôÿôY‘ÕS9.Çýak£’¯^â¥é—%Pt›Tß•k–FŒé3$þœÄûä’J×Ë:»ScýÐM€é=â7MÛž»Ò¥e¬êmÖ, ÞfEàÒ˜0Hz*šËˤÎîM?t`òmOR¦bno¬Ø²Ì˜tbtÉvK3+ë»r hÉ&Ëiޱ5Á¿Ó´ç7 5‹ŠÁºÁ²^2&¹Yy‘§Ûty×Ùë‡nLï¿iºó[·…lÔ}LÍÒˆ1ù=•“øD³¯vî:»S4ýÐM€ÉíüVÆ6HÉF,̬<“n\‹sÀ$imà¥=œ¬­‚ g„ðUÆ4+~œþÌÇ%ä¿5Ö. 5¦_wl·£ý;í&»ScýÐM€é=â7M¼Ôת2X¬ÄïfiĘ _'&›ßèšbYgwЦº 0¹ß1EB}©ç çíŠ1Ù‘  $v¶È˜ìÃÊÀ1*c Ã#½¦Yñ[·øE”òJí.P/NåÊï\¹’ž,èT´›ìNõC7¦÷ˆß4Ýù9KÔv¢ª+·]¼Í$–ëÄCNÍo|µs×ÙÛ¢„îLìv~ã BÑ(ó‰ÿ‡1qàcŽžÙZ-:XêÃúq‘þ£Cbîÿ˜xZü6ÝÓrRW‰ßõÒˆ1 þú1}lv¼»í:»ScýÐ=€‰ß#~ó¬ømS۳ͺoÚê¥þÛŒBÆr1¦XžÆ7ó©h7Ù¢é‡nLnç·Ù–((a2å‚–d›kŒ Ç2nÞ®dÔÿ´ÁÅ_¦YñÛ·Øxà€9×–õÒˆ1å__ù\ƒŽÉ§¢Ýdwj¬º 0½GüæYñ[÷ 6YX¿ •øÝ,õßf„ï¹rQžNåøT´›ìNÑôC7&·ó[”ÛÅ”•º@)´8%…Xlc2»¬Ð­Ï©œ¦’ô?囓xyVü6oªõß¹i°l–Œ)¹;¿K‰O¬üT´›ìNõC7¦÷ˆß<íùm–ÔÉšòêvzið6ÓoÒ辶‡¾Œ¼ëìNÑôC7&·óû˜7E1Jb†Uwåˆ6ç›ÌSx±óÛ†>E2wG ¾º•›xÙnÿ¤Ï$¸?Sµ4šö ÿ=• O¬üšbYgwj¬º 0½GüæYñ;ǤÁ%Âò—1µK#IàWc*øLåÇÏîM?t`r;¿s Ö=¡1˰êÇDCÌ 4qÜ#YkLÑ,ÏR2Þ¯NIáiñ[÷H… —”UÀT/ jÌÆ2ÿjL婯.E»ÎîÔX?t`zøÍÓžß’M¾Ñ·ûg#öÇ©ZhL1Æk‚F~êüΗ‘w½-šAèÀ”ÝÎoÊÖ£¬ÄQŠMžZdL¤{¸ ‰“n0hÕÁ’ò1Ï.Žþ˜ò¤ø]„ÄYB` UKJ³4bL”Ëé\Ž?~v§Æú¡{S~øgÅoŽh/I”ðTâw³4bLº¹„‡·Y>í&»S4ýÐM€Éíü6§<}Ç–lO>¶ÝHv 8æ0¶ín<¿“î#9™Ä4öLù`š¿mÆ^61>ƪ] YÔÿz~=NIÉ—¢]gwj¬º 0½GüÎÓ¶')F]£ìX1¦fi|*w˜`|F//“:»S4ýÐM€Éïü¶ñdvÍ_‰'þKŒIÿ¥Øhƒád™1‘nFJĘÅonåò¬çw0·£Hb<°òüj–Œ >vºŸ»rðÈÊO#ï&»ScýÐM€é=âwž¿uKÁ®›šy~LõÒˆ1qúuˆé¡Á2ŸŠv“Ý)š~è&ÀäŠß9,Ø©šõ3ñÊø&3¡,B™)íLcýºv°”{:eN_½+—'Åï30J0®tÌfiä+/\îƒôôòË?~v§Æú¡›Ó{Äï<+~£~XÌì žÄ[/:¿Âï‰I~z›Šv“Ý)š~è&ÀäŠßI8ë¸Ø E¨EÆ$ŸË¤Ê–JY¾+§¸rÐmŽîéè«Ó¬ø‰Yÿ#æJ.h—F¾ò®C»tûPc§¢Ýdwj¬º 0½GüÎÓߺY€p âºó»^2&úuüŒrrЦ\íÜuö¶h¡{SqÅo,Å&[{ŒÛ/jL iQRa¥[B«“xË¡1e̬Œâ›Fqe¶ó›íG*ZZ!uƒe½4dL~k ^~ålçn²;5ÖݘÊ{Äï2)~Û¦!p¶.ãDMó[µ4Ò˜’\÷˜:âwI?~v§hú¡›“+~gT©?4êÿ´4ðÒl»í^`ެÉͱaÑó“¾—LÉÕ‡¿)~—é— L7‘Ø9cÕ.Ð,<¿bâ»ÆÊ“µn¹¦XÖÙë‡nLï¿Ë¬øÍ o ¥#‡ùÏ_ÆÔ, Þfºí¸½r$<¹ –SÑn²;EÓݘ\ñ[ÌS)¦œËÑ+¹:%%š3Lk[¹ãaÝê‹!C)ù›WRÊlç·¾VÄ&Jéf¼òüj—F¾ò9ÿöÊÁSS9Û¹›ìNõC7¦÷ˆßeVü&›‰¬»$¡\]°l—FŒ øê11ñûáº@9í&»S4ýÐM€É·=‰¦§–h×ÞÊšµîq°Ævþ¤T+.» P‰"1{ë/ÓôÀKkš¢I®Yy³4œöÌ·ŽiÝ#5vM±¬³;5ÖݘÞ#~—iÏï’ØÞÏ’Ji.ñVKƒ»rþó6+O~Lå2ò®³;EÓݘ|Û€h&èŠL1ɶ|:¿¥èÖ"ÛPW[“ š©o‰üU`š¿#YÏé¯ÄÕˆðviĘàw®œ0>阧¢Ýdwj¬º 0½Gü.ó/­áæ¸;Qyå´KÆ”®ëÇÕ§¢‘{Še•½-šAèÀ$¾í JÈ,ˆŠ1a cBÊ!q2ç“%£¸ãa¢@€˜ù›“L‹ßæ“ ÅÚó«]õ1Iùõc‚øÐ’"—¢]gwj¬º0É{Äo™¶=É€%¡DßfíÒ€1þú1¥”“\^&uv§hú¡›“o{’“ùSdb«–”g1Ø0ݸLÇÃ,Ù€ÜN¿Ù`)“âw dCn£Ýì†ê¢x³4:•ãxw~~2#øñ³;5ÖݘÞ#~ˬøMcÀˆrªºr›¥c‚pkL1=ٞʩh7Ù¢é‡nLþÀË£õ lÎI\´Ö5ƒ€’r±gŠQ«îÙüÔl/7¾h÷/À4+~‹YrRÖGþ«c¶K£>¦þã.NåäT´›ìNõC7¦÷ˆß²Ðù-dÙ%V£uÚ¥cJüñcxz›ý¶sÿÍîM?t`r;¿S°«ƒ +¬ß_X2Š;Öb²Ë`¯ŸÊ)ÏJ¬àÆðÝ­Ülç·nj“¹C›ÛŠ1ÕKÆÄ1ýÞ•ã'3BÉ?~v§Æú¡›Ó{Äo™÷üÖ úfÿ@ÉÏïjiä.`3ЮS9|º`)·‘w•Ý)š~è&Àäw~Ç\J¶ígÆ’WS)¬dK²¾ÀÓØ„²îc*%ÙdëJůÓ¬øÍÖZe£Û¸À_VÞ. SŽ·ƒ¥Ö=´ ˆüøÙë‡nLï¿eVü–kh ¯ø¿]¹íÒèT.ß,¬©ÐïÊÅp*ÚMö¦hF¡[¶ºƒ1EÝs„Ã7K^=•Ëñð¾ä¢¿xYu°T@"@” ŒÏÿÿÀtþyÆ5–Áf~ÆÍú®rh–F§r%ýNâ‰cè5ãŸÝ©±~èÀ„á5â÷ùy‹¦¤À‡ËFÈ9VÂd³4`LJ îÎo}Ñû}LNE»ÉîM?t`r;¿u#†‰”X]ícÊæ[F!JKCé>så²õ|+*åo^I9ÿ<5¦0+ ”Ì/¸>`©–FÊÕù %‡'`‚?»ScýÐM€é5â÷ùy‹&g»lªƒÔ]¹ÍÒðT.Ü~L‘ü˜•€ÿøÙ¢é‡nLnçw2Ø`MëIw¡‹Û‰ž€íõSîÆþ2&}8›!œâwiÖö$*‰³}¥‰8±¦jit»ã¯¯|_cR¾þãgwj¬º 0½Fü>?I‘ˆ™“~{ja²Yu~ýÇ+'ø–úJúñ³;EÓݘÜÎïæBi “îpÇ®H‹FU4wëBLiu®›E\$ Ší§¿LÓßÌ IÉ ÕS½4ª±ðë.?½ü®vî:»ScýÐM€é5â÷ùyO9æC±ñŠ¡ÔÃë¥Ñ” « $<“ÊŸÝ)š~è&Àäv~'¤Pl+lûª5Æ”£nõ©Ìº;^™– ÇÃ%FpFÒ—ÿÛÎ?ÏD‘ÝÌd;g¬ïÊÕK#SßMc|¸] ÌúÇÏîÔX?t`zø}~Þã¢)hY(úå‡ÔØžTK£))Q®I¼#Ào/“*{[4ƒÐ=€)ºß)•Âf¼­?<®˜PZXFnúTQ¾µÈ˜ôá$%è60)Íü¢QÜùç×X¶[”dLN©êå×, Y9Ò͘üÛãŸÝ©±~èÀß#~ÇYñ”¾ÚìB)©FÐ,SL¿SR™öÿñT´›ìNÑôC7&·óÛ~bÌIBŒX–S!ÉÉŒœŠ~[Oå²ù‡ôñƒÂ/Ž?ÿ<ãË%…H†´Uƒe³4œÄ#×]9»öä7Xb¼¼LêìNõC7¦÷ˆßqVü„`Í‘Rªý³4bL®·èÿ|Иâ©h7Ù¢é‡nL~ç·þÌ!êbÝO-SøßÂ@v 7‹pYÄ«gÒ¿‚“pø&0M‹ßÖ =S¿þS»4ꕃø«1•‡¹r/E»ÎîÔX?t`zø'Åï,!§BÉ|Í*`ª—o³LáfLŒüÐÇùÇÏîM?t`r;¿cakßPTR„YcLB)—¬¤‹u+¸Æ˜ôaд” 6-í›À´ ~³¾*û5Yy»4<ùÍ·Æ„Ÿ®6¯Æ~í¿Ùë‡nLï¿ãlç7ë×Ç®›*E®¼rÚ¥‘» â}*§O<“ñlçn²;EÓݘÜÎoÝME%ˆ˜½ØÇdÁ®º‡dÝÈkŒI3‰M1(¸}•1M‹ß‚fNU)×âw½4¼ïû˜€á©Æ.E»ÎîÔX?t`zøgÅoýC”(Ñ&þåêo³4bL)_?#è—Ò¿+‡éT´›ìmÑ B÷¦äv~G²ïPJ!QÉ+3+1Åf̫ज릇:ô“>L&Lë6Pÿ Çÿ˜ÒtçwNAŠÑ@Icj–†· Êåù6?ý¡Æ®vî:»ScýÐ=€)½GüNÓ/ (ÅhÓÕ©\³4š’Îa„ʘ˜ÊÃÛ,]S,ëìNÑôC7&·óÛü3L´@f²kƒKŒ)F ”t­ÓçáÃUˆIÙÖðá¦YñŽFtk}ªü˜š¥‘Ž™éwÚsxC ~üìNõC7¦÷ˆßiÚó;Ú«•(Úë¢ÞÊUK£S¹nwÁü±tóŠæ2ò®³;EÓݘü—©ä@ŠÕ)–ý˜¢™ý”M­<öKŒ‰Ùº5²@Ç0‚¯Ó¬íIŽº­$ÝØR©,Ú¥+—ü;‰çé/¦ÓˤÉîÔX?t`zøf;¿!¢ÙÿØXÆXÅ5K£ ×Ío(ôà•ƒélçn²;EÓݘ<¿…,˜ƒŒ%èŠ1ÅQ¿uÊ™Â[*Ƥ3ê§Eeüð¿Ó¼í‰MLj‰Çêå×,XùÇKþôüƇÎït{™TÙë‡nLï¿Ó´çwÎ@·×!Äj+×, {LàÖ˜r~0ŠÃty×Ù¢é‡nL¾ç·¢Š¾lª/w~Ç¤Û .&È’M›]cLú°Í³+&‚Ãný 0ÍŠßbã·I0CåùÝ,jL?ÒKc §rI~üìNõC7¦÷ˆßiVüÖ G´¡Œ© VŒ©Y½Íòï ç œŠv“½-šAèÀnçw …­9Ò(O÷_WŒ)) k +¶{]dLú0ÙþQrÉ…¿L0íù @BR¨=¿ë¥‘Æ”èbLâÈ0„ËÈ»ÎîÔX?t`‚÷ˆß0-~ënƒìà«p®çÊÕKCÆt÷˜>ŠæR´ëìNÑôC7&ßó[áÈæº*ÛKŸáKŒI )+´@ZÚÊ}.Šâ¹(6â7Oå`Zü¶[s®¥R_âm–FîËæÓIžjìR´ëìNõC7¦÷ˆß0+~'Á`VÇ%¥Úó»YuåÊ=‰$<å©h7Ù¢é‡nLnç·Í3G¥J‘õG_ÄkM1d ¡ ÙÇ.2&Q&‘“âa ôUÆ4+~”‹T2ü• Ú¥‘ƒ%¥ûä·`~¸+§¢Ýdwj¬º 0½Gü†Yñ;ÎϬ_ƒzJJ½4ê1áûæ7”üȘNE»ÉîM?t`r;¿‹YRe”¬¼'­MâÀ̲ÛL8,2&ë!Óÿ о+¾ L³ßbCòRɢ©Y1&’_‹”ž^~g;w“Ý©±~è&Àôñ¦;¿“ F¶)XŵKÃI¼éòüÖ­<\I«»ÎîM?t`r;¿ K ºŸÓÍX’¼LúƒØœÕÆ=’cÒ‡‰“!SÄ4¤[ÿLó¶'©”H(ÄÚ] ^é˜OåÌϯ±ÛˤÊîÔX?t`zø Óß’JÔo‘¾-¸rl–Æ]¹÷©\ùb§hðj箳·E3ݘÐíü.TH·1ˆMx ‹ŒI÷lw¶¬S'®jLh£(“Ê• ß&œ¿3ÛÕ?ý•Êç¬öKjµ4bLï^¹ò™ÊãÕXüñ³;5Öݘð=â7N{~g»/bÓÕV®YjLð;%•ŸNåð2ò®³;EÓݘÜÎo±Îåw$ô-±È˜PÿÅœ>—Ú>³Ù}#YSê7iVüæb¿LB$âúo½4bLÈ¿ž_™4&<í&»ScýÐM€é=â7Ίß%èŸ$Û,²ð˜š¥cúÏ”Ôø@³ñT´›ìNÑôC7&·ó[A)–c;%Žv%Æ”„ÍôD9bÌ«“>\Ì“cb¢Ú¿Ó¬í‰~œÈœ5«—_³4êüŽò{»€ŸŒâðô2i²;5ÖݘÞ#~ã¬øm{…PldÛçOþßI¼õÒèæ÷G6s EF»4÷Õ­Ütçw0å¦@*Í´çfit3œcè•#?ÕØÕÎ]gwj¬º 0½Gü¦iñ;Fôg­ø¡¾+W/4¦\þÓcòä•C—¢]gwЦº 0¹ßRà˜ƒG)äÄK –FzõጊÈqIü>¦hs ÙüÆoÓ´íI¤‚A7b©¦zi8‰ïcÆÈ5vy™ÔÙë‡nLï¿iºó;r¶û¦Tb¨ü˜š¥aS¼o~—€}L|µs×ÙÛ¢„îLìv~‹]½*¨Ô‰ÓÒ%^#=l÷#ÐþÛzÃCÔKù+Ó‰gÅï"a(Çt¤ ˜š¥‘Æ”ã͘ì#~¨±SÑn²;5Öݘø=â7Ïv~ÑB¶+XÊ5K#‰ï)©vÅë©hÎvî&»S4ýÐM€É÷üºûŒ)`†5Û#=ʶ ›/¯ö1±”PÌvõŸýMwž¿£µÀ§¬ÿþŒAý05K£Ë|OI±›m5v*ÚMv§Æú¡›Ó{Äož¶=I¸äŒBe{Ú,Nåè÷mf“MŠæò2©³;EÓݘ|Ïo6u\(1ÿ¼Õ))¬ˆR¢îÈÄe?&¶=oLfy–âWiÚöDËQÒ­eªN~›¥c¢pŸüJ|²=áËˤÎîÔX?t`zøÍ³â7&Ým†¢«­\³4z›•_K¥ÆOEs*ÚMv§hú¡›Óƒç·î "š#bÀ²0L÷ØÈZJ9)UÌaÕ]@¶½œè?^Ñí›À4+~+—¤<ÎÓÿžÊÕK#‰óí+/éi®ŸŠv“Ý©±~è&Àôñ›gÅo,l­ø”#USRÛ¥c’ðëÇDáA˜äSÑn²;EÓݘ<¿SÑýX „eq¯99qPH2=‡úu͘ôõ/TDlÐßiZüÖͬ5¢m•ø]/Nåø×Á²@|ð•çKÑ®³;5ÖݘÞ#~ó´ç·dÑ=ƒþû³{ÿ¯çw½4:•+ÿq„ò ~çËÈ»ÎÞÍ t`ÊßÖ…Äz$™–Æ7鉒™*/ŸÊE…C$àD߼ě§;¿m* B ‰TÅÛ¥aS¸4&cå:f¾Ú¹ëìNõC÷¦üñ;ÏŠßÀÖÂÁ¹$.g~µK£»rŸÛÞgWîÓ©\>í&»S4ýÐM€é©ó;–`ÆúS/Oâåˆd¾)lÉK –Ÿ‡íêp‰aÜù/À4+~“MÉ+I‹2W:f»4òc¼uL%”O5v*ÚMv§Æú¡›Ó{Äï<)~›D›ŒûÛ»½š`Ñ, aøÏ |ØÊeüñ³;EÓݘüÎïh‚…ùŽÄDy™1eP‚Èô5¾ìù­£usЭÜWÓ¬ø-I!6$ȱ½öT/çÿ¸ <ÖØ©h7Ùë‡nLï¿ó´øm#àCÆK=W®Yv~—_Ižf~åKÑ®³;EÓݘüÎoë_2`H™òò”ûvd¥‡Òjç·>¬|Õå˜þM`šxYŠéñÄ6eïo5K£S¹øŸ“ßT4¦|M±¬³;5ÖݘÞ#~çéÎo£¯Ùîe}ný·] ^0&»y¿ÍžhöÕÎ]gwЦº 0¹ß1&éϬÔQòÒVîsAÂ.á” ß•ñ “Š1éÃRtCRñ›âwžöüN­wAY U –ÍÒèääî•“˜ŸÓeä]gwj¬º 0½GüγâwÐ÷²™'ÙTéúmV/KºßfùÉó»„?{[4ƒÐ=€©¸ßÑÉ|¤0AÀÕS¹’²RD±)Nº/[dLÅn¢Jbë°ø"0•Iñû˜#¡ŸENTŵKÃI<ò{žŒâJüñ³;5ÖݘÊ{Äï2+~>M¦¥ Uƒe³4z›!üö1zèc*§¢ÝdwЦº 0=t~Û4]Òý”îÆÖŒâŽßX÷q¡è¦,Àع¤bL6—EÌoÜÆ´|Óö¤ÌŠß$ Z·h%~7KC_yþícÂ'kÝr*ÚMv§Æú¡›Ó{Äï2+~ëžK鈾—éã ô§+·Zv~Ü'&%>hLüìNÑôC7&¿ó;F°A%.¼ª1 ç„ÀÁL`éJÊça²¾N ¤?Â7iÖóÛ,kbä6O¢bLõÒˆ•ã͘PßVO5vy7Ùë‡nLï¿Ë¬ø ŒÆJ{‰·^ž˜üº ËÍ>í&»S4ýÐM€é¡ó[P¹Kâã¢Æ”‚°PŠ`Þ"‹§rú°‚"ê{?Eü.0Ív~s‘Í¿¼ž+×, æ|ß•‹ž€élçn²;5ÖݘÞ#~—Iñ;‹]·£ùý-šfiÜ•{ïÿ‰Ÿ,)Jùñ³;EÓݘüÎo뺎ŠI!ÈbS2i)Yw$ýíד=|èKJØ"}Ó©L‹ß(d@P¤Jü®—Œé¸Ô|2¦(ñÁŒ°\ŠvÝ©±~è&Àôñ»ÌŠß©è¿˜¸¹’Ò,f~•r{~Óã” ?~ö¶h¡{“øßÖmšÀÕeÆS°{¼ È†«SRìa3c¥™Âß&™÷üN̄拓*wfiʤ\–AXä6ò®²;5Öݘä=â·ÌŠß0p‚h/èJün–F]¹œîÎo@ôP4§¢ÝdwЦº 0ùßl7i–àè ]eL`#Âí`.d\œ+gsf;Ô/îWiVüÖK‰œ„S¤ê®\³4º]€ùfLAà¡INE»ÉîÔX?t`zø-³¶'h·ƒÌš*a²YiLYî>&¢'ÛSÁ?»S4ýÐM€Éïü¶9CJ]ì kÃL&*(¢ßd#O–5¦B6[Eßþ)§o6XÊlçw–d((c®G„×KC—TøícÒ"{¨±³»ÉîÔX?t`zø-“â· …HÖ^\0W¶§íÒHcÊå>•#|¤ÙE»ÍîM?t`ò;¿‹ LOȲîåS@Èlóá Ëê\9} Ø”o7©¿L³âw¶“‹’‚uºUמš¥Qçw‘»ÆJ O/¿SÑn²;5ÖݘÞ#~Ëlç7cˆ¢;?ˆX÷15KCËß{L\ÂCç·œíÜMv§hú¡›“ßù-ÉZc0ênNÒÒ0#=)›Ý[QÊ#«–ö°˜ÏÛóß<•“iÛ"E”¦»USRš¥‘SüõüÎÈO5vy™ÔÙë‡nLï¿eZüÎG Dɱêün–†žßáöʱ©&nÑP¸í:{S4£Ð-€‰Ú?]<í²uíaXœ+§»1eŸ©˜¥î_W“„C²9¡üM`:ÿ<ãËúRA‡ô«_» 4K£ ð{WN„‡;í&»ScýÐ-€‰ÂkÄïóóMa})'ë– ˜š¥c åîüæÏ¸p¯hNE»ÉîM?t`r;¿S`ÓyÌ|;Ò!-1¦ÌÌvÕîs¹È˜2‹P úßœ’rþyÆ5–3¥%[³i³•«—FŒ)ÿÇ%5?Œ£pµs×Ùë‡nL¯¿ÏÏ{¢hJÑ×sÉÖF[Ûž4KCÆôë.È…ýæ7 W;wÝ)š~è&Àäv~+׉úÃZ7›5õ⩜¨ÙœðÀ$˧rJ/C¦pœ|˜¦=¿3Ådý ‚¡öü®—F· RøÕ˜2û§r.#ï:»ScýÐM€é5â÷ùy‹¦õ–e;É)ÕÛ¬]ïÿïI¼D—x)œíÜMv§hú¡›“Ûù­;)†ˆJ˜ìcYeL‘’Í2Öß6N\w«û˜(eE¶rú*cš¿ Û&\о.©~ùÕK£S¹ï^¹ÂÁoIQ^õãgwj¬º 0½Fü>?ïqÑ”A ØÕE©¯¤4KC¯œ¯·ÑCW®în~üìNÑôC7&·óÛö›HkÖºŠjÊ·rÄlLÊê]9}8b°{<_Õ˜fÅoýË™NIêÛÍÒè®\”_—Tà'éT´›ìNõC7¦×ˆßçç=Q4%Ù4ëPÌ½ï¯ÆÔ.“;çšß½-šAèÀÝÎoE¶Ž¢؆¼.2¦Hhê —¸d{òy¸”r´*(oû"0ÅYñ›rN‰t‹”Íöîï•”ziäù…p÷Ê >måâ©h7Ùë‡îLñ=âwœ¿m2’ˆÔ-{5ð²Yõ1¥_Æ„úu|(šSÑn²;EÓݘÜÎo%kdúŒ9‘Ew›£—mN_FXÕ˜Ø &‘µ•}sàåùç×X>Æ").±íü®—†Œ)ó͘ÒÈ0ŠW;wÝ©±~è&Àôñ;μ-aý å$õ]¹zi¨1Å»+W_m[¹xO±¬²;EÓݘüÎo!`=ܘW=¿M„eÁcÅ¥aÇÃúVlRžÉã+ÿL³â7Û 7ÉY_/ü·ÆÚ¥¡Æ$¿žß€O/¿SÑn²;5ÖݘÞ#~ÇiÛ !… øè ù¯íI½4bLŸÞ¥ÆùAüŽ——IÝ)š~è&ÀôÐù8¢¹¯3®v~G‰Q7r <1,w~Û¥{ýûKИ¦;¿‹þ>G#{s*×,N~KþícŠñAcŠW;wÝ©±~è&Àôñ;N‹ß¥]kd†Ú•ø]/ ý˜âÝcrÊÔ^Ñ\ŠvÝ)š~è&Àäw~ç£'&0ä´L‡L”¡mç„Æ˜)“ÍoŒ€¾º•›¶=Q ÓÍi¶i•Õ]¹fixW.]îP˜ý»r//“:»ScýÐM€é=âwœíüÖo{@¶¯\*©YjL”o‰ÓCS:Û¹›ìmÑ B÷¦äv~ÇŒt ZŠp KWRÒCŠÆhÍP²:%EÖÊšRƒþ ¾è.pþy&j,"*ÕM‰Šâôßk–†Œéþ@–ôLé4òn²;5ÖݘÒ{Äï´`{b£–•ŒD,0ÕK#?&Ýr]o3x Ùé×Ëäov§hú¡›“ïù]Xôå^𘠰d{b¤“nS¶©ëaiDøça…CÝçƾÚ.fÅofs!µñ-Ÿ«ÝÿÕ˜ê¥!c ¿Œ‰ÒƒŽ™NE»ÉîÔX?t`zø¦;¿3r.xL"kºr«¥‘Ó¯3à“QœÓŸÝ)š~è&Àäw~ëïŸt/¬t–OårNçœo\³=ùËŒÉúþí5ë·ì‹ã›Î?ϸÆ2Çh™"WÅÛ¥cJá¿“x.ЧËÈ»ÎîÔX?t`zø¦Åo»ÂÀ$S»4bLðû6ƒò0¾™Ò¥h×Ù¢é‡nL~çw€,fcÉÖ³t%å‰Ð6ÆfœÎcýºÑ˜ÀMÙâôU?¦óÏ3®1Eh¶[¸`ÕÇÔ, 'ñüúÊ—íéT´›ìNõC7¦÷ˆßiVüfÖJ– –P “ÍÒ€1åÏAëGcŠàOI!8í&{[4ƒÐ=€ ÜÎoC b&w™`•1Ùu±&Iý÷šµîçaã—!²9“|˜`Zü¦l§æçYù1µK# ¢ûä7#>ÕØ¥h×Ùë‡îLðñfÅo}±³rX œ« íÒ€1±Ð}b¢›‡v8í&»S4ýÐM€É÷üóüFÈÇTäeÆÄú­ƒ"‚J<—û˜*fÈøUw˜¿í¶îô1×㛚¥!cŠ·ƒE òpò ðãgwj¬º 0½Gü†ÙÎï@€rÐo~5Á¢]iL)ßîú•x¿álçn²;EÓݘ:¿M¨—áË}LæL y<å»Ö˜LÔ:&8‘ÈWiVü¶¡KÊþsäz|S½4º+Wòï$ÞŸ^~ôãgwj¬º 0½Gü†Yñ›‘[O^€Pu~7KÆDüÛcb­´EÃ?~v§hú¡›“ßù-IAÔœÇt+——IdÉf©°z*C.6%xŒjÿLÓß9ÅÍ‹·ÞʵKC?&¼{å´Äž¶rW;wÝ©±~è&Àôñæ^ç×—køü™ÿ ¼¬–FŒ)„ûæw ðD³ï)–Uv§hú¡›“Ûùmçj¹a.¼~WŽ™¬™ ⲓ~³ì+†E)×7ïÊÁ¬ø­äM¹[´mÖ}LõÒˆ1%¼5¦‚øÄ˜NE»ÉîÔX?t`zø ³â·~sôoõ/’jwfiĘBºÝ"ć<í&{[4ƒÐ=€ ÝÎïs$³ Òý窓¾ÀY s„aéJÊçaᜊn#Ó7Ç7žqÙ`$)TªI<íÒˆ1q¹ý˜²Èƒ\€×Ë:»ScýÐ=€ ß#~ãtç7æ$•ÆÆRw~×KƄ·ÆÓÓÍo¼Ú¹ëìNÑôC7&ßó;ÚY?Å”Q²Æd½41q°+«ã[%5c²&k "‰_½+‡³â·?É ™U*VÞ,Nå$Þ½räávžŠv“Ý©±~è&ÀôñçÅo"Ý]“Í8­Úš¥c‚ß·Y¤ðT4·¢]ewЦº 0=t~;Õ-Ù\ eÆ$ÉvA¿*«ŒI¹RQš)º7É_eLÓ/•<ëH/+ÆÔ,S¤ûT.Ó“»^S,ëìNõC7¦÷ˆß8-~ëŸC‰ˆ¾1$×SRê¥cJ|wå†Ï¬ ¯h.E»ÎîM?t`r;¿£sñ$kV^eLÖ ¡û ±)ŸËŒIaIwrY(|õJ Ίߺ;ÒÏ#•”uûU1¦ziĘ¢ÜŒ‰ó“µžŠv“Ý©±~è&Àôñg;¿sŒ!‡ÂŸ+‘ÿ¦fi¨1ñ5WÞ¸ÂCç7žíÜMv§hú¡›“Ûù­)}ÿ*RëA÷ «ŒÉœK3”2qâ_3&;®RLCTxú*0MŠßÊxSÉf‹ŒR_{j–FôËʉž&ñ üøÙë‡nLï¿qÚö„õOtc¨ºùÝ. “Í úÕ˜žîÊÑåeRgo‹fº0‘ßùm¦ßÖ-ìêÆê””ˆ“îT2hŽå>&LBÌŽqÜ6þÀDÓ/I@·¶ø™÷goµ4òü’ø;‰'ãS]S,ëìNõC÷&zøMóžßZ`&UÛ´Û¿ÀÔ, ÞfÈpß•Svó°•£ÛÈ»ÊîM?t`r;¿K–˜1Q>æ»<<üA]Æfö‹õ‹(KÀôyئI…¾©1Ѭø J®$˜©vÊ•»@³4šÄÃt3&Né ˜NE»ÉîÔX?t`zøM³â·õoà1Ô47“xë¥cŠá÷T.>Ì•':í&»S4ýÐM€Éíü6t›;YŠ +Àd¤G¬;"J&XÚÊ}F% ;IÁoú1Ѥø]tƒTR¶ ýþW/¿ziäùÅ¿· 0óC»ÑŸÝ©±~è&Àôñ›fÅï¤ßžh£p~bLüãgwЦº 0¹ß C0“úí)i‘1Ù<ØBc ý®,2&}˜™&F%ߦYñ[äb»Rýîÿ½]Ð.S ·Ži³±jìT´›ìNõC7¦÷ˆß4+~ëw‡Šî¼DB¨ÞfÍÒàmfӊηY:Nªý¢9í&»S4ýÐM€Éíü¶»$Y9¤Ä1cÂƤ\@P¿)ŠnÍÛc2‘$˜ðÃÝú`š¶=±±ÀbÆšNýßvzi¨1¥ûv"ã0]^&uv§Æú¡›Ó{Äoš¿}³‚õp„Æ©Z0&È¿÷˜B|º.ÀáÇÏÞÍ t`bWü.”l?‚íÖ€Ia]‘X©–ÝÄýú/2&}Ø&?)°Yá_&ž¿3™+²ÍÊË¡bLÍÒˆ1Ñ&ñÈ“QŸŠv“Ý©±~èÀÄï¿yZü6ÖôÅn ÕV®^¼ÍRNWSÒwÏÃQ._ŠvÝ)š~è&ÀäÛž¤œY÷rÅäoZÕ˜8B´ãx$ƒ¦EƤ'.ʶl²Ì7/ñò¬ø­ ^w÷G7{LõÒhv!åp3&y2ŠãSÑn²;5ÖݘÞ#~ó¬ø­»k6«D;e®¶rÍÒ€1¥È×”Ô$á鮟Šv“Ý)š~è&ÀäÛž°Ù´êk8HàCéYјX7bÂ6¶4LÈDcâbGK”­ûk<”î_€i¶ó•ó*ÀZ;:WßÍÒˆ1•_Ï/Oî|¶s7Ùë‡nLï¿yZü’õÝco¢TÊ5K#Æôp0¦"á ˜.E»ÎîM?t`òÅoÈöq$ûöèÿ-2¦YD3ÇP$®ö1嘣nxBÊ¿:ð’gÅo, åsà¿íõÒˆ1%º{åôUõ$œŠv“Ý©±~è&Àôñ›§=¿ç„mÎPµ•k–FŒ î{Lʘžn~óeä]gwЦº 0ùâ7‘BÆh£åÂjSf{,å=„«wå2CD}ý'´’¾ L³ß)dýâsŒúSÕrA½4êüÎrß•3ð‡“?»ScýÐM€é=â7ÏŠß©€=@’CU4õÒ€1…”.wAýv„šOE»ÉÞÍ t`Ê®í A°»n1šSKŠ‹Œ©EóSL1®žÊéÃIÀ†Œ³Ò¦/Sž¿S´ŽQ›\R5Œ Y1&á›1qxò•ϧ¢Ýdwj¬º0å÷ˆßy^ü> "mÂiªN嚥ÁÛ,”rõ˜$e Œ)ߊv•Ý)š~è&ÀäÚž°ÄgÝ 3.2&³ gÊæy"qÕIæ€Y ¾y%%O‹ß9˜"†ÖÁ²Z1& ¿³ ‹ÓwÆrüã¼;í&»ScýÐM€é=âw™¿£ÞG3yµQ\³4`Lú¢¾OåŸzLÊ©h7Ù¢é‡nLnç·Ý½:Î3HÅS9› Š %È«}Lö0ÛÄLVðUkÝ2+~ë~N«—_»4:• ‰~Ó“»@9í&»ScýÐM€é=âw™¿9Ö¿0Ƹš’Ò, §»Ç$!—‡vr*ÚMv§hú¡›“ÛùÍÈ9¤£ÏÁ|nW“Íï 61“˪ç·=lvjZ!Œï³ü 0ÍŠßf-U¬çV’TíÍÒˆ1…|;X*.=±òSÑn²;5ÖݘÞ#~—Yñ;C,ºc°£e¨‡ÔKÆdZíŘž¦¤È©h7ÙÛ¢„îLâw~G‰Öæh»v”¸Æ˜×ÍêMkÊÃëncÒ‡u©;Á@ö¦ø0ɬømÇ“rˆvJù˜š¥cÊá>ùU~’ äT´›ìNõC÷&yø-Óâ·n68€$ÝwT[¹fiÀ˜rË+'Q¢‡ý¿\ŠvÝ)š~è&Àäv~›S¾92é/A©¬kLÇ=÷BJWû˜ìa6Ãñ€_vIñ»D%Ç#×õÒ€1™3×ŘìSz¨1øñ³;5ÖݘÞ#~ˬø)¾ÖõýN¹bLÍÒ€1Ñg†i8ý]ÚäT´›ìNÑôC7&·ó;šð,E™ ¬3¦bjl°I\³Öý<,1¢~ÛÇõE`š¿ÍGȱªÚ. ÓïìÂDñ‰•ŸŠv“Ý©±~è&Àôñ[¦;¿‹Y÷éËÙsTŒ©^0&¥÷]9kî{(š«»ÎîM?t`ò^*{´v»6^`LJNúr!RT^ÚÊ}¶OL …Ù2~˜fÅo”Ìúv º«Å¿½ríÒˆ1Ño“îYŸXù©h7Ùë‡nLï¿eVü1]9pVæ_ÑìfiĘ0þ2¦ðX4§¢ÝdwЦº 0¹âwdÓ`B´ÝgEwåö¨î*‚"üê©\²QW Mæ.¿Ê˜¦=¿ƒBˆ~÷{©YMâùõ•›WüPc—‘wÝ©±~è&Àôñ[¦^ŠM `Þ=05KCÆné±Ç„Ã5ŲÎÞÍ(t `âöO¶dVâ>ŒiMcâlã„RàôÿècÒW¿è0òÝÎ?ϸÆrQœÍABÂÏ}€?§rÕÒhOw“2R¿‰WæÇÏîÔX?t `âðñûü¼ÇES[/`¶Óí\S³4`L‡EÇɘìœû¡hÒŸÝ)š~è&ÀäŠßˆ±H’d,2§%£8#=vŸ%1c±“µUÆ”K@ä" Œß¦Yñ;@«›,\5ñ6K#Æ|y~A$òuL§¢Ýdwj¬º 0½Fü>?‰³2ÉSÝ`Y/ `ºÞfö­z*šËˤÎîM?t`rÅo²©Á¨›*ë&âEÏo”)¥p)$‹såÀ^ʸçúb»Àùçטµ¡g…ê’ª–”vi¤1}FÏŸ§r¾òºþñ³;5Öݘ^#~ŸŸ÷¸hJHYßî6¶µT×Ú¥cJŸáÊcÒ/ä0ñŸÝ)š~è&ÀäŠßœr(ƒéD ‹Œ ƒVqÖÈ46¡¬“>,v2§„‹ÆÖÿLÓâ7„ŠÓ%¬:¿›¥aÓÝ+‰nè.úÇÏîÔX?t`zø}~Þã¢)6Û´›;G}%¥Y0¦˜ÃÕ•›"òÓVîšbYgwЦº 0¹¶'úÃf¥=%Ù§åÎoBý•C€²è`i)Ó ¢_Ü/ö1ž‰CÝs)NB.Ÿªø¯ŽY/ ÞŒ)>Ê)Õüñ³;5Öݘ^#~ŸŸ÷LÑè Ú|íùÝ, “]Y½SÀ‡I¼šêÇÏÞÍ t`Š®í ³BH°®u¢%Û»l¡{@ë%ŒB²6Œàóp*™l€Ó„@õÀgÅoÊ! X·‡„Ê(®Yõ1¥|;XÚü€‡;í&»ScýÐ=€)¾GüŽÓžßhæÐÅ\:þS³4`LÊkn?¦€é©h.#ï:»S4ýÐM€Éµ=a6Í>ÚŒNEŠU)IŠúòæ"p©]àó0˜u•Í—+_´Ö=ÿ<ã³f®hv1'®¶rÍÒˆ1‘ÜÓžõ—ôïcr¼½LªìNõC7¦÷ˆßqVüΑ­‡ó1Œúï]¹z©ÿ6K6äfLúÆ(šSÑn²;EÓݘ\Û΢{ƒŒ9Òáõ¶äÇE¿öbÓhÜ#Yû1AÉ4Œ§eþ 0MŠßŠ‘#FBÊÍPÕziÀ˜ ÿjL!¡WŽ#ýøÙë‡nLï¿ã´íIÍ(˜*wf©ÿ6Ó7uº~Æ(Ÿë¶^Ñ\^&uv§hú¡›“o{ºʤŸCI!¬jLQ4m‰IÿŸŒïáÖ–Â`TȿʘfÅoV„ fáb>S³4êcb¼zå¬=þ‰1Šv“Ý©±~è&Àôñ;Nw~cNIÉsÝ•Û. Sápu~ëv=<1¦«»ÎîM?t`r;¿í$Q÷R’u3VÒªçwL,Œ%#bU)¦!˜‡‡î¿ÙÇg;¿m>žÂ,$»Yü˜š¥cRjó˘òc:Û¹›ìNõC7¦÷ˆßqVü!ý‹ØD©=¿›¥c*\®S9&|ИRøñ³·E3ݘ’Ûùt 1*H¤eÆtøÖ(åBÝËjç÷qRB›ÇûMÆ”&Åê¾++ۡʾ¹YM{¾ÌM:ˆ¶'œâŸÝ©±~èÀ”Þ#~§YñÛ\ƒì,^_•‰W»4`LvÒz1¦’L¼8¥?»S4ýÐM€ÉíüV–dWpµàí”g ˜l“‚ŠiæsN¨{‹Õ))ºÝ±aW¿º•KÓâ·nfC±ÑÀ‘*ÆÔ, SÒ ×¥c =\çt)Úuv§Æú¡›Ó{Äï4íù hïV¾]M»4`Lò­1|˜ÄËé2ò®³;EÓݘÜÎïCª°ñI…ŽÅ‹så”pa²qBœÇúõ_Æd“R5}ü›À4ßùlT©µ0–Jcj–FŒ)”Û%UB|båw;w•Ý©±~è&Àôñ;ÍŠßh7ª 0 s5"¼Y0&Æ{JJ̹,º“N¬ëç‹À³ß6Þ6%ÝYQ5¾©Y0¦PîÎïtÎ1ôjìlçn²;5Öݘà=â7ÌŠßæ(²ùŠ¥úS³4`L„ò˘>>^ÑœŠv“Ý)š~è&Àäv~S¶–o@ýö&ŽK¶'Æ=©p öÛI‹wåìá¢ìU”påôÍv˜öüVj£ûÙJÈõ´çzi4»åú$Æ'V—‘wÝ©±~è&Àôñ¦=¿Í¹6˜J«ï‹Zcª–FŒ©ðµÿÌSR.#ï:»S4ýÐM€Éíü6o;Ìbv’a±ó;Ù=;ñ”4•EK{Øfƒ+]*Bß4Šƒé—Ñ\5)FFRÉõÒhÚs9åC`.â7\S,ëìNõC7¦÷ˆß0)~g9„ÈSú+~·KÆ„@WI4k›‡¢á?»S4ýÐM€ÉíüDL”$X³:,Þ•Sla{ë¼p^²=9ÎÑ윲îI¾ê` “âw v­‚rŘš¥c¥ÍcÊáØØ{5–üìNõC7¦÷ˆß0Ûùmßu»YJu©Y0&»Ó~1&x&álçn²;EÓݘ|ÏïÌ™9Ú, ¨ÿk‘1s0ÛUzŸøWŒIÎ6–õŸ¿Ùdzâ7Ôe㎕µn³4bL9Ýž_ ßO¬üT´›ìNõC7¦÷ˆß0)~[ÏKÒwO ò%ð‡1UKÆ”ä·ó›@ü˜0üøÙÛ¢„îLèv~Û†@:f»uÜ*ÁÆD™TBdݾÂÒ•”ÏÃõÃc‰ú3|˜pÚó[hgÇ] YiL9Ý}LLOÅñ2ò®³;5Öݘð=â7NÛžXï'ë僪©Y0&ýÞ}LhWêý¢¹¼LêìNÑôC7&WüŽ¢bó1©S©Þ*c"ѽED}ƒÓÚVÎæìš|BúêÀËóÏ3®±l;¤ú×+±üÕ1Û¥!c¢ÛÁBé1áÙÎÝdwj¬º 0½GüÆYñÛöÔºER ¡ºÁ²Y0¦ˆ÷\¹hý…Es*ÚMv§hú¡›“+~ƒyH²Nå²8%%ÙŽÍ7%«§rú°"¢Ä‰¿êù³â7åmN^‰v@ùw+W/¦=§{JJRÂôÐ`‰ôãgwj¬º 0½GüÆÙÎoå°I%çø1‘ø¯ÆT/SäëÄ$⣞íÜMv§hú¡›“+~#ÙqœÁÓás·È˜ìŽ;gÛ‡õ>&0_R®Å€c_Þ¦ÙÎoå»9ÅB’¢TÀÔ, gží†Àîx¶s7Ùë‡nLï¿qVüVâìBu¦’?¦jiĘ"]]¹Ñf<Mùñ³;EÓݘ\ñ›Ä6c³Düt­0& €1¡måV;¿m˜%“Þucòխܬø­ô¯%½BTkLÍÒhv!ð5‰W?'ûf<í&»ScýÐM€é=â7N‹ßúJŽ’õKPª¹ríÒ€1Jwç7ð“%]Šv½-šAèÀD¾íI‚ uSe.U«ÒoоÁ!Q\œ+gK1Ã3ÝûŽç‹ÿ0ѬøÍfãBEé_¬k¬Y1&úõ•7Ã凋?~v§Æú¡{½Gü¦Yñ;Û{½`ŠDõ0‚f©ÿ6³A×Ï!ƇÎo:í&»S4ýÐM€É·=á\JJK(‚«}Lf™ŽX¬5lUcÒ‡QAIÿù¤ö›À4-~“²N¤h[ùÊ·KÆ„1Þßʃ\@—¢]gwj¬º 0½Gü¦iÛ“œmÀ­þOWÈOåê¥þÛ,Šäkÿ•-<4¿ÑåeRgwЦº 0¹¶'6ÐÕ†(e%NrŒoz¨—1Å$fZr´3-3&}˜”°)2bøª»Mw~+I ö•ºó»^0&;<»Óá‡îרÕÎ]gwj¬º 0½Gü¦ù—©èŽ!×o³viƝýLåi‚ÝS,«ìNÑôC7&×ö$&2³|6â‰W€é8ßTf@Ñüu'Üq+Ƥƒ`7‡MPÿLÓ/ƒ]±sÊ1î^ÖK£iÏ×ɯ]|ª±kŠeÝ©±~è&Àôñ›fÅo´;ðºñ1UG¹íÒ€1}âbLú½|Ò˜NE»ÉîM?t`rmO¢µnCÄb^dLÆx“ð1_<-:XÚä[,¥„¯6XÒ¬ø]bLú™g{¨Üš¥Ñ´çø«1E wåH~üìNõC7¦÷ˆß4k{Rt³ ÊaÉ<6þS³4`L忌)>u~óéeÒdo‹fº0±k{Ѥo³ËC kŒ)ŠÝ[{ʪ“=Œ!I‘oú1ñ´ç·nf!éö4@5Œ ]Í.”ß»r1ÈÃÉ/_FÞuv§Æú¡{¿GüæYñÛ"l¶w@‰UÑ4K#ƤcR\zèÊåSÑn²;EÓݘüÎo $`çcf¾Ä˜lzSFVLà5kÝÏ ãWmOxVü¶‰/úŸÉšª>¦fi4í9ÿjLŠKO/¿SÑn²;5ÖݘÞ#~ó´íIÐïO*ÊüC»•«–Œ)ó}bã£í _^&uv§hú¡›“Ûùu[@D!— ´ii+g¤S0CPÉ$ãÿš1a2éõÿD¾ÙÇijâ7+Ó• E¹¯T÷1›¥cúX~¦=—ô ~ó©h7Ùë‡nLï¿yVü}ñX—°ÄˆUƒe³4`L9•ëm¦Oz½¢¹¦XÖÙ¢é‡nLnçw Zâ%Å\8êÿ^dL¤ZÇ*m‚ÅÎo{ØLWÄnçojLyVüÝ•†Y¬Õí/05K£Ù…|°Ú#?ܕ˧¢Ýdwj¬º 0½GüÎÓžß!3r͹2Šk–FSHwçw òL—‘wÝ)š~è&Àäv~§È±|äëD\dL6É EåZú=YdLú0r ‘¯2¦Yñ ‰Ýe&ýP*ÆÔ, ÙÈ™³Æ¬³í¡ÆNE»ÉîÔX?t`zøgÅo ¤ïeÔ×k¨S½4Ò˜_~Ìv‡õáĤ„?{[4ƒÐ=€©¸ß ¬1Y?›Ðx¸"­0&ÈÉæÌ°¤Ä´ÚǤë?\I“¾è›ßeÚó[w¤’ ƒrÞúJJ½4šÄƒr3&&zÐ1Ëeä]gwj¬º0•÷ˆßeVüú½§Ca®L¼š¥‘Æ$á—1áÓ̯’~üìNÑôC7&·ó;™¯ —Lú³/]â ¶$6]…\t°´‡Q·g}õG;ZÓ­¦yÏosÔÒø ²=i–Œ ïI<$OS¹¼«ìNõC7¦÷ˆßeVüfº[(æ˜XþÒìviĘÂ=óKŠ·Ú‚S4§¢ÝdwЦº 0¹ß‰ßÍH¿KkíÖžšíš›î^ƶÝc2 °ºd»°øE`š¿³`¥:T‚„ ˜ê¥c‚l|fÒS»@9í&»ScýÐM€é=âw™¿•[ã C‰\Mâm–Œ .Iôe}`’SÑn²·E3ݘÄíüVÚ’n@)¢®ö1)&Ù0å`óò*c:¤óDQt?ßôü–Yñ[ˆl¾{ œJe­Û, §=ÿNâ!INE»ÉîÔX?t`’÷ˆß2+~çQô%°±¤h–Œ ‘.?&A9.XzÀt*ÚMv§hú¡›“ÛùPl’½¬›ÐEË£ožÓ1¦ŒÖjÆ”@•”\š­Ó7iRü.1Ø9€~á)Ö.©ÍÒˆ1Q¹O~•”>8XÈGÑn³;5ÖݘÞ#~ˬø­,GÿEöåcj–Œ àÖ˜J–ÿþãþÍ©h7Ù¢é‡nL~ç·}ƒlA°Ae«§rƒb ŽAs,2&{*£~ÓX¾)~Ë|çw´3BÊúƒUíÍÒHc oÆ„ùAc’»»ÊîÔX?t`zø-“âw–TtË •T¤¦ÙõÒ€1ÁÇÉæ`Lñã`éÿøÙ¢é‡nL~çw²†ÝÝ2êϾè`)榨¿5SªöðyXÿÁJµ¬aždôð¿Ó¬ø­Û¯ ¨¿‹õÝþ­±fiÀ˜’î¸nÆô±Ùõ€éT´›ìNõC7¦÷ˆß2+~ÝÀ‰ëËfiĘ"_o3ÝÂÄ'`:í&»S4ýÐM€é¡ó›ôÓ°yxQ>˜“`’b£8å Ãñ0D´ãKS·à«À4ÝùÍ ‚”˜¸zù5K#)¦ûT ?1¦«»ÎîÔX?t`zø-³âw¶íF4NòiWûï•”ziĘôÛxþŒ…é˜ùÕS§¢ÝdoŠfº0åöO÷¹+x8*iKÂÃ_ÆT슜Á0‡W“> ™Q™E´.¨ïÓùçט~éš/òçxä0UK£iÏ¡Üø± l)‡øãgwj¬º0åðñûü¼ÇES€Ñ€ìRVªOåê¥cÂx˜(„|.ô:Esy7Ù¢é‡nL¾ç·²ž¢ïÞdê.:XfAÔ…>oCÎ.ÚÁça"¶ `¢ƒê_€i¶óÛX¿òEbm­Û, §=ÿjLÑ¿ö¤{ç?»ScýÐM€é5â÷ùy‹¦ ¡ä€! …êĤY1&ÀëĤd@_üÖ„?~v§hú¡›“ïù-Fv”¼PŒaÕI?<¥ŸÖ½™ãÝ‚ÏÃf¬÷|¢î_€iZü¶?ŸÄÈ‘R-~×K£Ù…¥Ü}Lºïÿñ³;5Öݘ^#~ŸŸ÷¸h¬,e&4M¢bLÍÒˆ1ѯÆTXž€éšbYgwЦº 0ùžß™¬Wݬ7qù®œ~vLún‰ ô›¸ œÃçaÝñRJ"d8á_€iVü`³m–œë))õÒhÚ3Þ½rÇÅ`:í&»ScýÐM€é5â÷ùy‹¦(‰MJüõPù15K#ÆÂÕ•[ðc‚ëÓ©h7Ù¢é‡nL¾ç7™µîQçJ|5&ÎItoAŠ˜çÐcâlÃ×$`RL„¯Ó¬ø­ø¨(‹Œ1Ô“x›¥câtkL Üþ©œRŸ?»ScýÐM€é5â÷ùy‹¦DÎúˆBôqSú/0ÕKƒ·Y*åºù]0¢ßùã©h7ÙÛ¢„îLÑíüŽÇå 3Êq±]@I Xgä’tS¼È˜R*úC‰Cuë€)μÔK"-ÊÕK³4bLJ"/Æ¤Ïø –9ÞS,«ìNõC÷¦øñ;Ίß„BÁP(På.Ð, Þf)å«©„Oÿ¬L§¢ÝdwЦº 0¹ßÖy‘$ÑÂ4¦‡?¨Ë˜’M—l­ÍJ¼SŠ˜9÷ ‡Êù¿Ó´ç·Òݱ”„±öü®—†Œ)ÜÓž•Â0]FÞuv§Æú¡›Ó{Äï8+~ƒy°&Ž+ÆÔ, Þfñcgo3S„žÓ©h7Ù¢é‡nLnçwÖ7¯RžlþA6Õj˜”ôÄ„!éÖve¸à2Ÿ‡)![ïÓÕþ˜fÅïhû$cr%ÕîÍÒˆ1ѯ¯<<9Xæx*ÚMv§Æú¡›Ó{Äï8íù-Tèè{­€©Y¼Íâ§áÍ~Ƭ_Ì'`ºŒ¼ëìNÑôC7&·ó“nàLt£Dvx´Ä˜(Û´u‰v ˜Ë0G6O}üx¦| ˜¦^¦¤`ɬŸI5"¬]ÔX¡xw~Ûô`º¦XÖÙë‡nLï¿ã¬øúÊæffvJ0ÕKCÆt^I1ÆTâƒøËŸÝ)š~è&Àäv~GŽZæú©¶' Œ‰”!ê×#‘îåŒ#.1&}˜“nKlžzJÃF…¦Iñ[÷´¡0Øh¤ÊW¾YÔX |ŸÊ¥ŠLòãgwj¬º 0½GüŽÓ/õ%…DõQn»4bL&iœŒI±ä˜Ò5ŲÎÞÍ t`J®ø­ÈR²©p)†cˆ.0&LB€¦2Q\Õ˜u‹SôOR }³)Ív~³ ÎX˜Kª®¤4K£iÏåv°P†.[¹t¶s7Ùë‡îLé=âwš¿ Ú ¸˜"r=%¥Y1&¤[cÒW¾W.§SÑn²;EÓݘ|ÛÎdRDŠÔ]dLÇ ÙÄÀV“¾úCEF3Šûâ]¹óÏ3®1aÅÈÖûñœøs‰·ZÔXþÏ]¹ò°•Kðãgwj¬º 0½GüN“âw>ÞÊv;1V~ÌÍÒ1É/cb~&üñ³;EÓݘ\ñ9 HÌ|X*­hLÇÍ@›t¢$‘WSIÌÂCÿé›âwš¿Ù˜HÉb¶ž cª–FŒ ãí+¯».ßW^7Á?~v§Æú¡›Ó{Äï4+~ FÊfö±š`Ñ.SÈ׉‰î¼·r§¢ÝdwЦº 0¹â·ÄQ`ýÁé°B_bLŠf ìf˜¢ÿ«,]I96ýr´Væ¡rþ/À4íùs ¥ˆí½êaõÒhv!Ç{JŠÒhßW>§ËÈ»ÎîÔX?t`zø¦Åoýê` eÅëI¼õÒˆ1¥xu~ë?_ÜÒ¥h×Ù¢é‡nL®øm7RtCÒ*cB„¤_ûHhc>—,‡!ã(@ˆ¿Ùùf;¿­ ͰTâw»4š]ˆñwv¡< ¼ÈI~üìNõC7¦÷ˆßiÚó[7ÖÁ4ÅTêáÍÒàmîS¹ð‚ã\FÞuö¶h¡{8â÷ÿüoI¥PÑ •PаØÇ„˜ •¬9"Á0+dè?—X`L·þ˜`ZüÒOÂÌ¥ëvziĘnÆ>ÜÆ&¸í:»ScýÐ=€ Þ#~ìø­•Y—Êö´]¼ÍB–ëæ·3}°=SÑn²;EÓݘ\Û“‚HwSѬ»kÝÆÄ™”$¼'Æ!é©gNA‘-Kæ±EÝ¿ÓôÀËÄYá²~õ+©YO{þ]hæ >0]S,ëìNõC7¦÷ˆß0ÛùmwGŽ×k&¨Ýê¥cbº<¿Ùü€élçn²;EÓݘ\Û“£ËÑÌÇR>ΟWOå@² t@k±\>•£È…SRžùÕ­̊ߺŸÅ¨'ÇFün–FŒ)Þ½r6†þ¡]NE»ÉîÔX?t`zø Óß6KCß­…š+)ÍÒˆ1A¾¦¤²2b®\†«»ÎîM?t`rmO”2†ˆÅl7{§k§rvE8诗¬u‡9Ú`Hóeú&0M‹ßú– v´ª_þzO½4š]˜ÃíÇÛàR´ëìNõC7¦÷ˆß0m{bWÙõ«/Š\ÛžÔK#Æ”ÊÕ•Ë6ˆö˜./“:»S4ýÐM€Éµ=±=œÄ@ƒîBa‘1åx˜ d…˜LK[¹ãa,J,(ÊaÆðE`š¿YJ!óq±éÅïzi4í™çÊxðüÎp)Úuv§Æú¡›Ó{Äo˜¿­[Š}ÁVS³Ô›)«)éœÄÀåÁ]/E»ÎÞÍ t`B·ó)‹ù}SLø™À´â.p¸ugÔÿ‚<¾îV¹ (WµQ‡UúfNÛžèß/ÙèOÝÙÖWRê¥1cºý˜”¡‹Lxy™ÔÙë‡îLøñgÅoeü@ÁÞõ‹v©ÿ6Ìá3_ѾñIüÆSÑn²;EÓݘüÎBwT”ìü¢ÆÄJ´lbGˆI¸,NIч!X¯¼]â)߼ċ³â·Þ(Á¸H)•íI³4fL—Ž©Àôt‰áÇÏîÔX?t`zøÓßEÿ&ņyT–ÍÒ€17 Ƥç‰1]íÜuv§hú¡›“Ûùmîö‹˜x!°Ê˜ŠnÍõDáxéJÊñða-`Ó|á›ã›Î?Ï¸Æ ˆâd±n¨Í›¥câü{*÷ñ˜÷€‰~üìNõC7¦÷ˆß8+~Gýò ¾\V4»Yê¿ÍŠÒ¤r2&¢ L§¢ÝdwЦº 0¹ß!JÑÌrX¼+gì1 ¥D¶ÏqmJ J)Ö}ó/Ίß`•J±ÃâêT®YžÊá}W.0=Åá©h7Ùë‡nLï¿qVüÎ6$¨$Ñ—Wo³f©ÿ6+ú]¼é;û‰1Šv“Ý)š~è&ÀäÛž(Ÿ°ö÷ƒ9á0Ùh)‘R> _Ëâ]9}X’èk?JÎã‰vÿLÓâ·Â3ëïDY°fåõÒˆ1¥ÛW>†ðäù—¢]gwj¬º 0½GüÆYñÛÚ“‘Xì쨲=i–ŒIÿ´ébL@OWRèT´›ìmÑ B÷&r;¿SÒ–mD'®]IQÒsL¤ ú Ǥp¿È˜JʘH Â7Oåhºó›³èO#,”«áÍÒ€1¡œ#Âì°…þûûScW;wÝ©±~èÀDï¿iÚó;DdÈɆ+ÖíõÒ€1¥OÃÎÁ˜’Ѓƒ%]FÞuv§hú¡›“Ûù“uW*s¤‹–åhDBÝÇ)´-Nâ6ˆŠ YÕ}³‰¦^B(`s9†ê®\³4`LXòå`i-¨O5vM±¬³;5ÖݘÞ#~Ólç7x9ZÇÌ_ÆT/ SÐ-úŘ"ÁÃVŽÎvî&»S4ýÐM€Éíü°ixY1•ìrÈc*)ص@ Å<>Xû[4ú°~\Œ³òW=¿iÚö¤°Deo1J¬ïÊÕK#Æ”.ÆÖ:ty™ÔÙë‡nLï¿iVü¦æYÏöïJcj–úo³,èbLöúy(šSÑn²;EÓݘÜÎo Ýé*Â(4Å¥K%=ǃhv 6"f‘1ÂR.úµÍ9}u|Mw~c6·?Ò >ÕßõÒhvaá›1Řšxéj箳;5ÖݘÞ#~Ótç·°9&B PS³Ô›eeÁWJáwºÚ¹ëìNÑôC7&·óíõ+œBÌk –6`XS» V.ö1éÃ9êg•€0ò7OåhVüN6Kp}ÀÒ.¦=¸:¿E)éC¯Šv“Ý©±~è&Àôñ›¦=¿ C ºU’Ê(®Y0&}Eãɘ¬ïè¡hø2ò®³·E3ݘØíü>¶rEr±‹~´d{¢¤‡°ÄÈ6Qû˜ì^…MÕÝ Ìo^âåiñ;˜ G$)µø]/§=Óù=Ð_4=°r¾í:»ScýÐ=€‰ß#~ó¬ø |Øs`´ñˆ©Y0&›{3¦ô4"œOE»ÉîM?t`r;¿1óh•`ƒºóâ””’ƒµ“B6'jZœ+§+“0މv_þ›À4-~›NMÖ#BuW®YM{ηÆTl»üPc—¢]gwj¬º 0½GüæYñÁºøS–Úö¤Y1¦P®>&,9?1&üñ³;EÓݘÜÎïã–zRYÐî¦,2&ÝX(áɤOæ±mwŘrJmB9”ÂßìcâiÛ¶ 7º­=~›¿¶'õÒhÚ3àõ=(áñTŽ//“:»ScýÐM€é=â7ÏŠß`ïuŽí´¿bLõÒ€1Eº“éx(šSÑn²;EÓݘ|Ïo»©¦_œ 9-Åé‰6*“1@ÔOr•1E}AµÃ7Oåxzà¥è楾+W/SÀÛW¾È“ç_S,ëìNõC7¦÷ˆß<+~³DÑCŠR*KŠviÀ˜0ÉÕÇ„ŠRG¹|*ÚMv§hú¡›“ÛùÍh“õ0¥¬¸—.ñZ}Q¶B.–,‡•¥égF€e|ø_€iVüýº‡böwUçw³4ò•g¸ü˜lxî+?í&»ScýÐM€é=â7OÛžXƒ2éßDßî'X´K#ÆÄ§ømŒ ãCS¾¼LêìmÑ B÷¦ìv~³ c6á(ˆ§EÏo{V7ã¶uUž¸ÚÇQßúf8^â7Sžµ=ÑO!ê§!!B®z嚥Ñ$ž”ÃŘÌ÷¡ÆN/“&»ScýÐ=€)¿Güγâ÷a& ‘tã@µWN½4`Lö-¼'yhȧ¢ÝdwЦº 0¹ß¶¯M…µÌIV5¦Â9éþ•ìÎ{Zíü.æå›E9f ¯NâÍó¶'ú/ÅgIˆU»@³4dL·ƒ¥}®[¹|{™TÙë‡nLï¿ó¤ø­oû#ØáôŸ¢i—Œ)$¾y&óGÑn³;EÓݘ|Ïo¶q“ô?ù3wIc°Ñ )L˜PÖ“µ*Nº™–±ýå¿Ó¼ç7±õU§ˆ¡j°l–†“xäfLFsjì6ò®²;5ÖݘÞ#~çiñû0˜V&B)Õ[¹ziĘR.7cŠø 1åKÑ®³;EÓݘÜÎo}3ÛÌiá²èÇTJ¶öÌl+­ö1)ÓR4´q›v½â›À4?ð²`0I©Ò˜š¥á$¼ú˜rˆùÁW>ßS,«ìNõC7¦÷ˆßyRü¶‹ú·¶Z¹>1i–FŒ©Ð͘(Å'ÆT~üìNÑôC7&·ó[éNI‘²Û/û1 Ø–% évNÆ2Ñߢч¾)’ Ó] OŠßÀ:dÅnðs}ò[/S‘«ÉNú˜²üøÙë‡nLï¿ó¬ø"æ²̆½žÄ[/õßfL|¸lŒ)êÛ/šr*ÚMö¶h¡{Sq;¿ h‘SÄh2t^œ+'ŒYßá@ˆÌcÊ¿ŒI.!QÐMO‰é›}Le¶óۮ׈(Ð&®€©]iL!Þ“ÖØc*g;w“Ý©±~èÀTÞ#~—Iñ[0¢€ýý&Û¥þÛŒsÊábLçÌ\¯hÒŸÝ)š~è&Àäv~ç 6cZ=•ýúéfÌX„5£¸ãád”ÉèZwgþ 0ÍŠßY™›huØ•¢Š•7K#Æò5WŽ/ÿo§ÆNE»ÉîÔX?t`zø]¦=¿C2M"ë;V]¹ÍÒ€1•\.w„žŠæ2ò®³;EÓݘÜÎïœI·pQÑT+>/žÊ b1ƒ9‰EBYº’r<¬Ä0I°1NߦYñÛ,õ7JL‰ÿê˜íÒHcJ÷]9f|då§¢Ýdwj¬º 0½Gü.Ó/uנ̨peIÑ. ™£àɘ"?Ý•+×Ë:»S4ýÐM€ÉíüÖ­A ˜íà>ò2c"Òß1™AÞ"c"²Û,Áæ]eüæ©\™îü¶1¬?Q(Rû1ÕKCÆTîiÏÄéi+wµs×Ùë‡nLï¿Ëlç7ëyÑ/åŠ1µKÆ„‚÷©\„øô6+?~v§hú¡›“ßù-D÷c6@¡à⩜Ø-;ýž”ŠW5&L6‘îØ™dü¦S™íü¶÷IÉ tLü˘ê¥Á$ž\~'ñÀ9’Þ©±³»ÉîÔX?t`zø]¦=¿“î8(ØP¬®¤4KÆ„owŸîÊÉeä]go‹fº0‰Ûù!Eóbbζ£[=•Ó§C) kÌ´èÇd“ý¢•ð͹r2=ðR·àúV$%V,ÍÒ`v¡~×}LNžjìšbYgwj¬º0É{Äo™x ­YØLª>¦fiÀ˜ô5ÏçÛ̼¶rrM±¬³;EÓݘüÎoÓP•0Ô­/:Xši,ŠPÐ_ùsx…1çp ñMÑÚï¿L³âwA9îí‡XR%~7KÆÄ×Eñ`õö$~Ë©h7Ùë‡nLï¿eÚöDw lâ² h¬©Z0&sñ:ßfP$>4XÊåeRgwЦº 0¹ßÌ9è·ÈÌDW§¤è®5)›ÚbXtЇ!$ûø¢ÂøWÓ¬øm¬Ì9Ú=ì¿ÀÔ, Ói˜ðaL.ñ ýøÙë‡nLï¿eZü¦P‚‚Š@µ•k–ŒÉ†¿^ŒÉfÁ=Í¥h×Ù¢é‡nLnç7Ú°©„żq¥„EÆŽ™ÃQa aMü>Ö-Ž _5Š“iñ›Q·—SŒ±:•k–Œ)åô;í9¦§»í:»ScýÐM€é=â·ÌŠß)[°î”bª»r›¥c T~“n¿ŠæT´›ìNÑôC7&·ó;a ÂEì01Á¢ƒ¥Äã~„͆!–UƤ—¢»ù †oÓ¬øm"<ýêÛ®¿ÀÔ, SÌ®I<òh­+òãgwj¬º 0½Gü–YñÛÎõõÍ®_!LÕ©\³Ô›‘½ä/ÆdsºÜ¢)áT´›ìMÑŒB·¦ÒþéŽá„™Mc°I ö±àJç·HQ<ƒ _”¼xWÎ\ ’yÄæ _<•;ÿ<ãSˆÄ¬ÑúZ‰©jh–ŒI÷\—ŽIJŸ}¹ „³»ÉîÔX?t `*á5â÷ùy‹Æ®{ØìQÐW|m×,õßf¤_Àë®$ÿ®\ —¢]gwЦº 0ù/ ë¦@ôË–EÆC’\¢€MÔK×€‡É¢±‡õÝbÓ2Ëðá¦iÏoV®«ÛñˆA*ÆÔ, “Íÿ½Sɬ¼„ËÈ»ÎîÔX?t`zø}~Þã¢)˜S*6¸†s¨©^0&.pkL$Fñ%\ŠvÝ)š~è&ÀäŠß”A7búC‡5¦híA7KÉ&Ï.Óñ°è€õå_¦iñ;%²¦ÝžB LõÒ`ÚsþÕ˜´_~—¢]gwj¬º 0½Fü>?ïqј77ÙÈ×ROâm–Œ)ÇÄcÒïÄ;¼LêìNÑôC7&Wü.J Š.JZ—Úô7Ž@)ˆØµ¢¸È˜ì጑Cþ.0MÛž¶?cb¬^ÖKƒiϤ¸{1&^øPc——IÝ©±~è&Àôñûü¼'ЦI~Š)"±*šfiĘ®vcL$~S §—I“Ý)š~è&ÀäŠßbGýf"-˜a™1%°ë=Yù`É‹ŒÉ6òª»ÉüÝ­Ü´í Žú‹ Mˆ®^~õÒ€11ðÅ ‰>ã½»¼LêìNõC7¦×ˆßçç=.šl£^ôMQ ¼l—Œ)–|u~CzjPñãgo‹fº0EGü6ÞÂ1E%®!êháÄÿ`L@ŸöLûDq ˜Ž‡õó‚czC¡ôE`гâ·éø¶ï²áK•øÝ, 5¦L·ÆDüÀÊã©h7Ùë‡îLñ=âwœ¿só¥FÎR_â­—Œéô%;“~/ý –%^ŠvÝ)š~è&ÀäÚžØdÆ„ÖP„’â “ƒ1)ç±q—!GåˆKâ÷çaHI+”R†ûÀ¦Iñ[áYéˆî,9HÝ’Ò,SI¿ŒIŒâtýãgwj¬º 0½Gü޳â7 ØØå,‡Fû§hš¥þÛ KJ÷©œ¾³}?æOE»ÉîM?t`rmO"[—¤qW_¥­“b*JœÊ*c’cˆŒ†±@õ/À4)~sQ2E? ÈUo»4Ò˜.V®»ÝüÄÊ?Šv›Ý©±~è&Àôñ;ΊßdÞrœN—ê‚e³4bL6%õbLùÁó»ÄSÑn²;EÓݘ\Û“ˆl“›ÀŽÖx<«¤fLlˆž`9 ×Ð-‰îæ Ö¾ L³â·˜Wp¶ß¨öüª—¾òfƒ~1&› úPc§¢Ýdwj¬º 0½Gü޳âwÆBÍ01–º+·^0&Ixw~ÇÂd<í&»S4ýÐM€Éµ=‰Êï ‚î©2™™çcB¥+&¬ÉgJÊ c24Óm‰$ÝúƯÓ´íIIÊý”Œ †úo½4`LŠK÷©\Ê[¹ËˤÎîÔX?t`zøgÅï 6K2"ÆRM³Ô›!ü=>ý…Rü –ZZ?~ö¶h¡{Szèü¦T˜”닌‰õK ('!ê×cÒ‡u3§ÿh»Ë;¤[ÿLiºó[QÚì8“5~VŒ©^hLh>_'c§I¼%]íÜuv§Æú¡{SzøfÅoýê°½ÚI+¹ÝÊý]0¦Dp1¦ÄùiÿŸÒŸÝ)š~è&Àäv~Û&}X÷1–‰&¨¦ÙÎïhV]¶³¤@XÚ¥ÆTR¾$åå5v¶s7Ùë‡nLï¿Ó´íIae¯Â%R¬¯¤ÔKÆd‡Üc²ÁòEsy™ÔÙ¢é‡nLnç7¶ÙŒ)Ûï´ØùͶ{µ–ñ˜è¾‚1Y4ö0E»BœŽ;Ï_¦Iñ»D(ŒÊá@?“¿5Ö, fb¼ý˜ôWüï?îOå?»ScýÐM€é=âwšµ=)æJTØ|¦ÿM³4bL¥ü2&xêcJ§—I“Ý)š~è&ÀäÛžˆ(LŠ ÂK—xÿǦœ‘þ¶3'ËEƤc±«_¤á7;¿Ó¬øÍÑn 2Ç\5ñ6K£iÏ¿·l9?´¤¤SÑn²;5ÖݘÞ#~§yÛ úzç„R÷15K#ÉFë\ÊÉ Ü^&Uö¶h¡{øâwRÖ‚‰2Úõã¥+)ö5IJ—ìÜŸÀXÁcÊv %ÝÏåáÃÿL0+~g¶! ÖwWå`Ù, S”ßiϬŸðCŠv“Ý©±~èÀï¿aVüNPLΨ®¤´KÆnÆDºy(šSÑn²;EÓݘ\ñ›H³~w‚n?ÓÒVÎHržC4ÉËŒI?{)Å|s+ó/QñÕ,""WS³4`L‘ïÝ)Z/ÅCÝS,«ìNõC7¦÷ˆß0Ûù­_s§Ja¹¦f©ÿ6I|uå&ýJ>åÂÙÎÝdwЦº 0¹â·@L`‚O(´ª1åÙ p2eÆÌ\¨˜çwúfç7ÌŠßAŠÝE¢°bLÍÒÀ%µÞŒ ?âÕØ©h7Ùë‡nLï¿aºóÛþÖE¿;D±¦fiĘèvTÆôø6»Ú¹ëìNÑôC7&Wü>œmo±éÁ˧rL£Òo‰î—–€éxXÿÖ“2§oÓlç·Ri¾ -!VÀT/f¼°#…Îvî&»ScýÐM€é=â7ÌŠß1‹òŒÄYjkÝzi 1ÅÌ¿}Lçd¯hNE»ÉîM?t`rÅïHú'0ãó oáã„{© Ú“ÌZ V5&}í¬@ßþiL·þ˜¦;¿CÂ$vMrµ•k–ŒI·Z·ƒ…”§–¸Ú¹ëìNõC7¦÷ˆß0+~K !f{;K%L¶K#Æ„|w~›¿_4x*ÚMö¶h¡{:â÷Aó‚b 0ÙÌéEÆDÇ€3±Fɰd÷yôýâæñÃÿL8+~“ÝIV—ÊGú05K#_y›“sMâøLx*ÚMv§Æú¡{¾GüÆñ[Ú” z®|»4bL ×=¦ãÞÑCÑü*Ú³;EÓݘ\Û“ ̆’ÅZ¿WSN6I/ý²àø`­Ñ˜ôŸmgfºùýj»ÎÚžXãC¦>³sþÛ+W/ <¿nÏoÈòt‰O/“&»ScýÐM€é=â7ΊßAb²Ó,,U»@³Ô›)3ø=•3Ã뇢9í&»S4ýÐM€Éµ=Iv 7';HŒÃéncÒß“í÷µ>ɸz*§fóM&ô}˜&Åï]Íô.‰9˜ÿ­±zi4»0ß—šAÉÓƒŽ‰ôãgwj¬º 0½GüÆYñ;%´À¢/x¨Ûê¥Á©œ¢ÆÍ˜ ÐCžŠv“Ý)š~è&ÀäÚž$sû¡D„9/Œ†;“’¬˜#éJTVOåôa›Át¹oº à´íI0˜˜‘°²Öm—Füº¤J.xy™ÔÙë‡nLï¿qVüÖE±±Èf+Z]h–Œ‰®­œ†ä¡]ËŸÝ)š~è&ÀäÚž@ÈVåYr*W5&±ù½¨;‹`Gþ‹ŒIÎ6˜“¶oŠß8+~Û.\wµQ¤n°l–FŒ‰oÏoeLá ˜NE»ÉîÔX?t`zø³â7q(öÇÐo‚ÔîõÒ€1Q*W‰ÓÓ• ?~ö¶h¡{¹ß`±DIŸ+„KŒ (¨éç™i ˜>ëæ‘õ«†yì2÷ÀD“âwÑ¿^¶Ýeáz|S»4Ò˜~ïÊAæü cRüñ³;5Öݘè=â7ÍŠß`Æ÷ Ð:DªvfiÀ˜Pß;cŠŠv“Ý)š~è&Àäv~dÝÍ&äH`i+g¤‡ƒ"[±]Y›P֌Ɍ«“Bâq8ûM`šíü¶ÎÔ’”TYë¶K£S9”ßiÏåé¢8íÜMv§Æú¡›Ó{Äošöü¶iÞ$Ç”¡J˜l–Œ øöÊÑÜS]FÞuv§hú¡›“Ûù­XSÎ9 Òªçw)Q’¹×ÀØR©bLú0ÚÈâ€à›[9šíü.‚v›¹pÛ`Ù, g†[c²ë5v¶s7Ùë‡nLï¿iÞó;XŸ0€H}*×, „tkLú¢¦ÛÈ»ÊîM?t`r;¿!‰˜ ÓbƒåÿCÑÍ ’‚DN«~Lú00CÄDŸÀ_¦YñÛÚ¹RÝ–r}W®YÍ.Œp1H –§Ë?~v§Æú¡›Ó{Äoš¿ÁZ^³Ö±™TW[¹ziĘ4ðfLü4%…NE»ÉîM?t`r;¿M$Š1Ú–V`y®œù(šq·½Ái¹©`(ÅF7šmÊ7iVüŽYZ VVò[5X6KƤ»­x1&¤GéT´›ìNõC7¦÷ˆß4-~‡,’9ØÙ×_šÝ.Å_ÆTð¡]€/E»ÎÞÍ t`b·ó;±ó°Y`ÆÕ))lreÝŽïáÖßÍ#„#'ü0ñôÀK²RÊGð3;ç¿/ë¥cŠ.t«üL|M±¬³;5Öݘø=â7OŠß¹èÿJQ¿H¡¾.Ð,S¸S ü°ÿçôãgwЦº 0ùߠج¥{Ê{–€É®»eŒA”41„å¹rú0é¾Ú¯}SüæiÛ“SB!equS³4šöLáîüN\®¤ðåeRgwj¬º 0½GüæYñ;ênAX_ÕV®Y0&»Gq~¢=t~ó©h7Ù¢é‡nLþÀK¡£(GIRVOå83¯éþu<³²ñü>LOJ±Ùtß¼+ÇÓâ7…˜­ ¾zùÕK#Æôk5¬À”N~ùR´ëìNõC7¦÷ˆß<íù )™.s”ºÁ²^0¦PŠœo33O|*šËÈ»ÎîM?t`ò^’¤nÊꩳ„˜m"ï*cbÅBÛ÷š4÷Í))<+~ƒn’ÈPVÿïc¶KÆ~ý˜´(ʃøÍ§¢Ýdwj¬º 0½Güæé—$©¤B 8V'&ÍÒ€1¹-:˜ä‰f_S,ëìNÑôC7&àe°½æµv#=ìL ÌïE–çÊIÈÌk<ÂW,yVü$Ý$…Ã$²bLÍÒhڳ܇ Lüôò;í&»ScýÐM€é=â7ϊ߀`â YOfŘš¥þÛ,Éeâõ?‡`ý ~çSÑn²·E3ݘ²ÛùMÊY¬Æuç!iÍZ×HYˆÝñ‰¿'‹ÆfÈ,º3aü¦Æ”§mO4”C*§®€©YM{Žò;í9>üæËˤÎîÔX?t`Êï¿ó´í aÑÍ:ýÕ—xë¥þÛ, ÜNífÛcÊ——IÝ)š~è&Àäv~'ÝuRI(Êö¢ð¢ç7“Ù^JŒ$8nEjü˜í®í&»ScýÐM€é=âwž¿)gÓIAßõÀËziÀ˜JäëKÍÝõ¡h.E»ÎîM?t`rÅoJ™J—¸Ê˜ý#ÛD½¡×[͘Òáßa·‡‘¾©1åÙ—vï0*ƒ¬›xë¥cb£³WNÁñ;ŸS,›ìNõC7¦÷ˆßyºó› ™‘!Q]4õÒ€1q¹ý˜t?QžöÿW;wÝ)š~è&ÀäŠßBak(ÃP–€éhEâ 24oü5ñûóð¡šÛÛé«âwž¿)%%ÐÖ ¥xÙ,SL÷í±1¿ÆNE»ÉîÔX?t`zøgÅofó¦A(Öã››¥cÒ}Ö­1éäAü.§¢Ýdo‹fº0WüŽú“ ëŽÚhOY½+Çs`»W«îú°(„+g+™¿)~—Yñ[lÐy±ó‹ÏYíâê¥c¢—lf¦0S9í&»ScýÐ=€©¼Gü.³âwPÒ¯›ë Se{Ò, I‚›1éÃEs*ÚMv§hú¡›“+~GŠbd)'N«– …°HD…â¸Üù ú×OCI#Vþ˜¦mOÌK$™GD€ªó»Y0¦ã¶äɘŠBãC]^&uv§Æú¡›Ó{Äï2=ð2Ã1SÌÕ0‚fiÀ˜Pî)©ú­,=&åšbYgwЦº 0¹¶'ú VÂÂ(„Õ»rÄ J€œ¬º èÜœJ÷/À4ïùÄf›Er%4KÆ™®_)ezòc*·‘w•Ý©±~è&Àôñ»ÌŠßÊBÈæcÝ-5FqÕÒ€1!¦«+7RÈ'&…üìNÑôC7&×ö$E*Åì')¥P–^¬K°YÕdæºË–æÄdÞúôß_eL³ßÙUm0±Mþ˘š¥c‚RîÙ…™Ÿ^”³»ÉîÔX?t`zø]¦=¿!‰ UŒ©Y0&£ÁcÂÏÁ¾W4—‘wÝ)š~è&ÀäÚž$LI™ éGRðhXbL))&Ë’QÜçaý¬H7 ã^ƒ¦iñÏZÝYb®çÊÕKÆ”~çÊéO/¿KÑ®³;5ÖݘÞ#~—Yñ;ÛþtÓaã‘«­\½4`Lpçë·‘<¿åT´›ìmÑ B÷&qÄo;¢„¤Œ)ÚðHËŒ‰K<þ‚n,–Æ7}}-0&üfƒ¥ÌŠßLIð¸×µQ\³4`LAέœÍ.ÌOf„r*ÚMv§Æú¡{“¼Gü–YñÛf¾Ú±—¾dcíÇT/R¾>YëÊ©h7Ù¢é‡nL¾í‰¾|‹~ ¤›ƒ’—5¦b}ߺ5ŽAÆ^o5c2C^)!0ÊW5&™¿¡™¸`"kÁ­.ñVKƒû˜Rn3™ŒöPcðãgwj¬º 0½Gü–Yñ[¬~ ”‡\M»4bLÄt3¦Oc¿W4§¢ÝdwЦº 0ù/…‹‚Š’<ëGZ=•Ó×6Ù­ålæJ«§rúp 9s"ˆcºõ/À4Ûù­Ð|Ø›b&l€©Z8X”kí–ã“»€ÐŸÝ©±~è&Àôñ[¦^Ú1©ù÷1T,Ú¥cúu°Ô·ý#;¦XÖÙ¢é‡nLnç7„d®'‰£9¶­Nâ5û óü–ãpm¹)‹®@¡|u+7+~Û¥(ýÃøw|S»4`Lº£¿'ñ>¹ È©h7Ùë‡nLï¿eºó;Ff}÷D ©šùÕ,SäÛ >1¦«»ÎîM?t`zxIÀÙ&íY·Ã0Y+RÔ‡“¬ <>X«û˜¢Y‰r8º¾¾)~ˤømþ/º-eýû¥Ê©]M{f¼'ñ$yF òãgwj¬º 0½Gü–Yñ;ål·º’¾_K5¾©Y0¦ï›Oíß•“p*ÚMö¦hF¡[“´ºc*b* *@Ñò$^F0 *» ±ÚÇÄHfÈp̃€/^â=ÿ<ãË6ÐÎV“Ín«S½4bL¡ð͘>”¼»¼LêìNõC·&ý!ßLçç=.‰‰©"ÔïÏß®ÜviÀ˜bþícxè1‘ðQ´ÛìNÑôC7&ßö¤Ø‚\ô?ì¾úªÆ„Á(Û=ÞU ˆ£ ¼†ñ´Ì¦Yñ› 1ffëb¬îÊ5KÆdó‰o_ùòàù%áT´›ìNõC7¦×ˆßçç=S4GGrS4õÒˆ1¥Ûe#ÚƒEƒ?~v§hú¡›“Ûù²¹À„\8+\¯Þ•;s¶ßÊø`­>•#d‘XŠœí¾L³ßÆyÁP’©²=i—ŒéDùûm¤ÉCíÜMv§Æú¡›ÓkÄïóóž(Ó!ȾûëK¼ÍÒ€1„û®\¢Û §¢ÝdwЦº 0ùßÊu”¶Y X+ñ"cÒœMøÖÏ ¯oúÜÒ `¾¼Jd¸ü`š¿ ˆ(‰@¥>•k–Œ‰Þwål³úPc§¢Ýdwj¬º 0½Fü>?ïqÑà"ú…úÕoÛª¥c )ÞS‚Ïo —¢]gwЦº 0ùß”S(°Ñ^j°´£óÖÿdëªYj°ü< fP—t/†fNÿLÓßÁ~3<ÕÉo»4`L(¿³ mJÅC]íÜuv§Æú¡›ÓkÄïóóMI¦YLj¨fLÍRÿm¦ä ß–ÖÚïM¼í:{[4ƒÐ=€)úßh7¯²SdYk°<š-l”^‰9FÂÕ))v' ¥\rù*0ÅIñûèõÔ„‘ëáíÒHcJé>•‹ âwŒ?~v§Æú¡{S|ø§=¿µü!Šõâ庩^ê¿ÍìÅõv‘ñAüŽ—‘wÝ)š~è&Àäw~cÔŸ5¢ ? Ë~LH¢;‹£CÂ2c"aƒ4Ý–øM)Î{~£’GóI‘z¨j³4bLp›r¦ˆO:f¼¼«ìNõC7¦÷ˆßq¶ó›Xw…CBŽÕ]¹fiÀ˜ ¦û®\Lã›õËúãgwЦº 0ùß’yÜ…¾ÜǤïîb3xcN«wåì ¦˜D 6Gä›À4ÛùMEtGšX"7[¹zi4íYw¸c²kJ5v¶s7Ùë‡nLï¿ã¬øMR+ç/fÄ^S½4`L%ñ­1)ezz›Šv“Ý)š~è&Àäv~§Åöq%D;ú_dLÖ!™‰(Ûñøê”}XÔ' §ðÍ>¦8+~3†”ÀIþü÷ä·^M{N7Ö&ûPc§¢Ýdwj¬º 0½Gü޳âwF,Â ÉæUV§rõÒˆ1Åÿ0¦Nåbùñ³;EÓݘü—嘡Uɼ¤pЋÙí/OâŽQÌ—ÀŽ­¾L³âw¦œ… T¸jâm—FÓž%Þ÷1%•ñ;žŠv“Ý©±~è&Àôñ;NŠß6³Œê VEÓ,SÀû®\ éa+—Ÿ½-šAèÀ”ÜÎïHQI^D1‹[\½+‡Öº-æ¼a¼«5&+“rbkgþ¦ø¦mOP!2`€Ãh¡bLÕÒ€1Åßë6îáå—./“:»ScýÐ=€)½GüN³â7 2Ã|æúS³4`Lú=¼zLl ìÃÛ,Šv“Ý)š~è&Àä{~4µ^yK²ie«SÈ,…Ì>vµI.²”œ¿ÙÇ”fÅïLÃ!}ÁP©4¦fiĘ(ý2¦4¦t*ÚMv§Æú¡›Ó{Äï4+~Çmô¶}rÕÇÔ, SVð¸Þf¦Ü> þøÙ¢é‡nLnç7HX2HçVne®Ø. ­y•Ó‡«8Ê’é«[¹Yñ[©MN™90ÄJcj–†Óžo V–“NåÒ©h7Ùë‡nLï¿Ólç7@Ö¿µØöºß\/ “]…?ßfbWì·Eg;w“½-šAèÀ®ø-9 ~ÑÜqcY&»ÐúPˆÁ0žò]1&Û‹ëaÎ_m°„Yñ;Û¤˜l¦"œšËjiÀ˜¬âbLù!0Aüñ³;5Öݘà=â7L{~#ÇT„%E®Æ75KÆDù5¤ òy³9Esy×Ù¢é‡nL¾øms†Ì§\t7·6ðÒHO°K8æ/ ÿsÕó[†lFu óWû˜`ÚóÛ¦"q#õ©\³4`L9Þ5¦¯Á§¸Œ¼ëìNõC7¦÷ˆß0+~£òWʉA™y%~7KƤŒæº+' ÑÖ)šSÑn²;EÓݘ^êæ9gúŒ\9•³ûn6d8Ä4<ñ¯“51Ù”´(6$ü›À4Ýùmí±6 ÁKý¦fiÀ˜ø?½rœžÌáj箳;5ÖݘÞ#~Ãlç7ÚMO²iª­\³4fLùfL9>1¦³»ÉîM?t`zx©ÐrüÜö‹¬ö1)(é¾B¿((Ä«žßÇ-9Ⱥ%aüê%^˜¿Í½DA:éÏSÙ77KÆD)ß÷1‰óÃ}LÈ?~v§Æú¡›Ó{Äo˜¿!Û›G7J¥ßÜ,S’«ÇD©Í§ÙÒ)šKÑ®³;EÓݘžlOlH ²¹‡ÕÎoZ³yå8Æ–š1‘$Ý=ý¢éVð›À4Ýù}Ûv<Öâw³4`L„åwÚs~ðüÖßüÇÏîÔX?t`zø “â·DI!è˜ëßÎïviÀ˜°¤ëĤˆ|ì)Ú¢Áðãgo‹fº0¡#~/!‹°9Ü#.måŽ+Ð1ëó“2¯UÏïhFE!3ˆ_íüÆYñÛ,ëlæKITM{n—ŒIùÌÅ µÞäá>&žŠv“Ý©±~èÀ„ï¿qVüΉƒ²‘T V}LíÒˆ1éëýbLJð˜ÒŸÝ)š~è&ÀäÛž°u_+žP¸æEÆd¿:+aŠh¾á‹ŒII”ÍX|¤÷/À4+~Û”JÝaÊqðõ˜š¥cRØøõ•~hIÁSÑn²;5ÖݘÞ#~ã¬ø­;j}³’¢JÝcÒ.4&º1>låðT´›ìNÑôC7¦‡—æe£pQ÷rKÀd¤‡“uVJHÇ\˜EƤÛ^4gý(ßlÀYñ» Ký@š>¦zi4»0ÜþTQ÷áTéÇÏîÔX?t`zø³â·á °þÅP[ë6KÆ„rOâµ{íOÀt*ÚMv§hú¡›“?ðR_¾úoн§–ûê]¹…“°9Liu®œYwp4se­_~þyÆ5–‘Í{Ô3ý¿ÀÔ,f†ÓÆü˜]˜,ñlçn²;5ÖݘÞ#~ã´ç·èßúÿ¸ûŸ{z%M ÛëSÜ¥kq¯ÉøKðʰo A^x9ußÚhuË=3‚¥Oïˆ<™§~E2ù§ G ò½ÝwÞ鈌ª:'2øðað‰C[:i±•«L#ŽIé›c‚×;ÑHšKÈ»ŒÞHš¾ë&…©=ð2 YQò1á†^–û˜0¤d…ž4éò©œ¿¼ ²¶õƒ#ÂϯgœcG£'ùèÏ ¹ÜÊ•¦Ñ$žkàÅÑ*ÆwÓÉhWÑ9Öwݤ0=‡ü¦ÙÎoFÈb˳÷â—Bq¥i„˜ð=%5‰¦›Îo>Û¹«èuÒ \÷(LÜìüFŸÆ€™9§Äy©0ÍÛÈÛ$­@­¦×Ã~;È;¨\xýs…‰gÉo"bŒ8h*SiqL1É›c’»S9>í*z#Çú®{&~ùÍÓß ê ï)åT¦Ò4BLÄ×¶#]3æIsµs—ÑIÓwݤ05;¿½íIûD \íc ®^âW—Û^äl`-’üæiòÛÛà_÷÷‹û˜µi€˜"¾#z‘j¦‹Ñ.£7r¬ïºIazùͳä7ØNý­÷ÉZ? Se!¦˜®¹r²ãÍVŽOF»ŠÞHš¾ë&…©Ùù(êˆÉÞ$þ¹ª`é§qÁÏõ’¦eK ÄÏ|ð' ÓìÀË(Øš’¢ýIÅâW™FÓž9¼'ñ mîo µ£7r¬ïºIazùÍóä78Qš¼ë¦"¿ Ó1ý!œŸáæJ ¿í"z#iú®›¦fç7úH¹| —øú(Ö,9«í1fÂÕI¼þp:è-ׄúdašÖüý@$ärÚsi!&MßÓž)Þt~ó%ä]FoäXßu“Âôò›gÉoÑ,…ÑvØÅuÊ4@LùêcJÁ*ÓMa:í*z#iú®›¦fç·mãlu7¸ƒ>J[—,ó!ζ‹PV –9+'eW~ÿhaš%¿ U}`A±•«L£iÏÎ.Ìwwåød´«èë»nR˜žC~ó,ùMD…lëQ^â-M#Ä„øFLáì¿©“FNF»Š^'ÍÀuÂ$ÍÎoÛO)°õ+ÈK/¶R@õ¡ë2V.)“=¬V ýRõGïÊɼì úÙ$ûåœrAiM{þþ“¢ao&yk™Ñ9ÖwÝ£0ÉsÈo™%¿%û=v .PpL•i„˜"_ꂚñ˜‹Ý*L'£]Eo$Mßu“ÂÔìüF[ƒcÖÄÞ°–¶rz\áÅ*LPrº1ÙÃÙo¤2¨~rJŠÌ’ß¶±g6TKuÊ4šöœô­.à"¡7… ¿ÚÑ9Öwݤ0=‡ü–iÍoÛ5ŠèbÊÅ0‚Ê4BLñ½º»îÍ]9¹„¼Ëè¤é»nR˜n:¿9Dá,Ç%ø5Ää}Ûâ AQ`Ü#Y &{8©óq1~Ró[fÉoðc°_Èv¶…æWe!¦Þwåò ù-üÕŽÞȱ¾ë&…é9ä·Ì’ß~ í`%0kqbR™« ^ßJxw%ENF»ŠÞHš¾ë&…©­ù­!Edïq°Ý*Ç$‰IÈ{þâê”{X|(^r*L³ä7köæ[ïe/‡T¦ÇDá­+|w%ENF»ŠÞȱ¾ë&…é9ä·L“ßàêëÀÇà¶b+Wšˆ Âûj–Úþå¦ÁR.F»ŒÞHš¾ë&…©Ùù  ~6¢_ÔY»’â*sQÈÑ–•µV5¿ýáÄì¢<–&øMaš–= bŸ…Ú¦©”=)Mƒ³jø¾+áNW^.-“2z#Çú®›¦çß2K~û-Ó $âr‰? Se!¦×=&L7§rz2ÚUô:i®{&mv~G¿ ê-’†_^ÃcW“júL:hœW“?œ’† á“…I§^&µßÇd«ÎïÊ4â˜4à1…t³•ÓkŠe½‘c}×= “>‡üÖYòü¼í:ÂqÀ_ìÿ Ó`5‹œ®1È–n |µ£7’¦ïºIajk~ û–*èQ>$„VS’@¤š¼¥t¼+“?ìTÉ1¨å£…i^öľ¹à3Kc*Se!¦oÁoòº!¿õ­eRDoäXßu“Âôò[§;¿Q(Øîº ¿+Ó`5‹áÝù-"w}Lzµs—ÑIÓwݤ0µ5¿‰³jôýXqõT.#‹(¡Uã‰yb²‡m'ýuþ¨ì‰ÎÊž¤£¥ëèýY˜*Ó1±¾ÕbÎ7SRôÔ2©¢7r¬ïºIazù­³ä·AÍL~½^™Fˆ)¾ç+ú%ÒŽI嫽‘4}×M S³óÛ÷µVPÉÀ‹Ÿ)."¦ŒI‘m/tµÉ~ÝÑÓè“}L:K~ût=Šh0•/+Ó ÇÒ5ðÂBK‰›Ât2ÚUôFŽõ]7)LÏ!¿u–ü¶/€"h*8¦Ê4XÍ‚À1ÙºsÓ`©'£]Eo$Mßu“ÂÔìü޶/ßk8n’UŽÉö,ÙÞ+M¼ªÇd»¤>»`Rø(bšx‰ªÞ™]ò (L¥icV°ßêÑÅÛ…éšbYFoäXßu“Âôò[gÉoWõ›‹Á'Zÿ,L•i°šŒ"1Çut2ÚUô:i®{¦Ôìü6œ”ÔµÚ‚3c¾È¯LâµjF$è‡Ø²Ž˜ìa9eüdaJ³ä7û7´½»íg»@i!¦×‡ùBLnS:í*z#Çú®{¦ôò;Í’ß¶´’m­£½ùeaªL#ÄDtu劻)L'£]Eo$Mßu“ÂÔìüN®—])ÎK…éuödïI°ÿÁeÄd'ÃjüNê' Ó,ù- êð¶¿OEaªLƒSþîc >’¾]˜NF»ŠÞȱ¾ë&…é9äwš'¿ýöCæÈÂÅV®2h|#¦Sÿ»‘4oF»ˆÞHš¾ë&…©ÙùíZJ$êq°¶„˜\Q7È]Äë“߯HøÉñMi–üv(‚*Øvå? Se䘂^ŸG >˜ ]˜NF»ŠÞȱ¾ë&…é9äwš%¿]è0¼nO”Z9•©¿šåLñ%<ô׿qf½ÑcJòÕŽÞHš¾ë&…©Ùù-L¶Û'¨|€Ç%ÄD~…l'‡ÀK÷²mälãóI¡¸4K~kdóÎE ³6 “h oÄä×uÚ…éd´«èë»nR˜žC~§Yò;Fö›¢‚”Bq•©¿šÙ׊×dÇCÿ¦0Œv½‘4}×M S³ó[¢U ¶ª‡ðREZBL~„ìMh1¹¬>ø5`ø¬´nš$¿SŠ!(”“xKÓ1‰~Ï• >¨¡]˜òW;z#Çú®›¦çßiZö„Ù@¿­í®ûPpL¥i€˜\ÑæBLœñ¦0åKˤŒ^'ÍÀu”›ßœ®Øâ+ì½7Ë¢«[ûq$®*XúÃèW$ÖOrLyšüÆ” X¹ E»@e"¦ø˜b¾¹’’/F»ŒÞȱ¾ë…)?‡üÎÓä·$æ$¹ØÊU¦b —¸µ+œÝ¦‹Ñ.£7’¦ïºIajv~3²a¢€>ýLV“c8º¿YVïÊ'odFù¨Sž%¿ 52Wù§’ü®L#Äô­}—ç3ŸŒv½‘c}×M ÓsÈï<=ð2“É1ÎO˜]šˆÉûú/ÄD¶þÜ$Í5ŲŒÞHš¾ë&…©ÙùM®vÉgõe 1Ù0ù˜•(,sLö° ymú$Ç”§5¿…0Z©¶½-`‘c¥i„˜^§rÙ/ÞÞäØ%ä]FoäXßu“Âôò;ϒߘI(¹Ö—Seê¯fÉ/a\ˆÉ‡~Ý$ÍÉhWÑIÓwݤ05;¿)BƒKIAõ¸6¸„˜ì?’‚«ã-sLö„èUñ£…i–üFu]© !‹«M#Äè:hÌ*z‡˜NF»ŠÞȱ¾ë&…é9äwžx "š4Ar ®Ÿ…©4õW³dP8^ˆÉ‡ûÜ$Í5ŲŒÞHš¾ë&…©­ùí÷B2Z©fŒºz*gkˆC c­·R]@ ¹¢ä¤†>Ù.g;¿)%A"!üì•«MÄÄôB⎘^Ê ;Û¹«èë»nR˜žC~çIò[SòUÝüU Ù“Ú4@L|] coxn%M´ÿýjG/“fèºCaò_²•4à—r,Í}/ä%òÛû›½gË q€¥­Üù°ËÈ$N]àúz&rŒí³`Û”Ú¿”}L•i€˜ÌÿBÙvÉÍÂd¿Ù›Ñ.¢7r¬ïºCaò_ò!…éú¼ÇI“Ž/Nö ÅâSm ¦@zõ1‘­øMŽÉ~³kŠe½‘4}×M S³óÛÏw ðpñ[oK[¹ƒîOìÛñ„‰–ïÊÙÃÞE„Ç÷Y~S˜fÉïC3/È!—§r•i4»0…÷$ÛK6¥uì7;í*z#Çú®›¦§ß×ç=Nš%Ûb‚ŠÎïÊÔ_Í\:èBÚßéò.£7’¦ïºIajk~ÛàC§ÑµÞþz 1вmÆ\inõ®œ?L’3€•¦¦ÙÎïD~<)É»‹))•i4íYßWtüÚM“Ç´ßìl箢7r¬ïºIaz ù}}Þã¤IVBISLEaªLýÕLýúÅ…˜è”§h$|µ£7’¦ïºIajk~‡ÄÙÔ˜Ž«´+ˆI“dq'Nü Ää Þ(Púù}}=ãS Šâƒ¨DJiÝÊ4BL”.ŽÉ¥pšºòÞ&ùÕŽÞȱ¾ë&…é)ä÷õy“ÆÞï©ô©’EaªLÄä"[b:Æ´“æò.£7’¦ïºIajv~ÛdET"úœÎ°Ê1‰ Íί­"&Ø[+0Œ› ~S˜fÉo¶])׬ ±ä˜JÓhOïÙ…¶[mJëØov2ÚUôFŽõ]7)LO!¿¯Ï{œ4® ¶öEò/ægaªLÄ„˜ùBLèw´›IÏvî*z4×= Slv~[¢s±M(¤$þþÐbbTõK=œŒùë19?œm•HÏf²¦8K~gÛÓZ¥d¥Bó»2f"¾SHíKûÍNF»ŠÞȱ¾ë…)>‡üŽÓ/=‰)àboe &Wñº“ ¹IškŠe½‘4}×M S»ó;{›€OÂó³ÿ¥Âtèòúe7ÛZ°ä5òû|8$ô¹vòÁá××3Î1e—ñÄÈ)r©`Y™Fˆ)ðu*gxRîrìjç.£7r¬ïºIazùgÉoÁHI•2‹wå*Ó1Å„oŽ nºrí7;í*z#iú®›¦fç·_’óÁMòà  W“¦äÚxöW³¬v~Ûî,ä˜í“w宯gœc>˜ÕÞz” %ù]šF“xß“x8k³WÎ~³‹Ñ.£7r¬ïºIazù§;¿]±OR¥r|Se &Ÿt!¦˜ùfÿ¯vî2z#iú®›¦¶æw ù ?דZä˜PÀ,“DWz]DLhOA²jˆ‡|õ ÓôÀËlÕÉ1$TSaÍ.$ºþ$—“¹[ü®)–eôFŽõ]7)LÏ!¿ã,ùÍ®ïží+Žöæÿ,L•©¿šI¶½Ë…˜| ÚMÒœŒv½‘4}×M S[ó›H³Ún#ŠbZ½+çÚh»‹Ïi™Kˆ) º¶²ä¬Fp}=ãÓ¤m+n›¤ˆ?oÔ¦áìBþž]˜Ûמ\v૽‘c}×M ÓsÈï8K~ÛW"¶] ׇ..XV¦þj次\ˆ)¼9Ê…“Ñ®¢×I3pÝ£0A»ó›2€dÃ,~ ¸zWÁñˆmÄüŽÄðÄ¿DLàê•€™•Ò'Oå`zà%EÌêƒîÊ—¥i8í9½F¼i°„kŠe½‘c}×= <‡ü†YòÛÖtÛv¹~aå°&{â¸@Ž#=—ÕR^=•sO—s¢†Õo Ó,ù ~[\´–¥ØÊU¦ÑìÂkà¥-„™îN~ád´«èë»nR˜žC~Ã,ùÍ9‘/~ªT ÅU¦b‚s+þ†9µG„»êW;z#iú®›¦fç·UfçQƒ-ñôß´‚˜ D¿cGšhõTΛ2]ú’ püðo Ó,ù->0ú$²Á²4tåó[ÆêïÝVNF»ŠÞȱ¾ë&…é9ä7Ì’ß¶¾ú©ö¡ìVpL•i€˜4Â¥Çt\«¿Iš“Ñ®¢7’¦ïºIajv~©Õ±Ìd›„UÄ]óÚ®¬ &°7–¬,%?üdaš&¿ÍÛ¿<ögäwiMâ9ÛP1xºá1áb´Ëèë»nR˜žC~ôæ7¤\ìAs¹•«LÄ$@òFLÐn¿Ù%ä]Fo$Mßu“ÂÔìü&ŒV'¿•ÂKä·ƒ¦cÌ»O†…am)ÓÑ)Ð*"}ô®Ì’ßÇÕ[ûö1²'•i„˜ä=‘J(„;Žéd´«èë»nR˜žC~Ã,ù-Â~/ "…P\e &?¦~#¦xw‰ÃW;z4×= 6;¿ÑJ 78dÖåS9ˆ$>Š€…b\*L¯‡½SÁ[¡N‰‡&œ&¿¸l` ZpL•i4‰GðR°°òÝ%^¼í2z#Çú®{&|ù³ä·mº‚k-û˜JÓ1½_ˆÉö27I_íè¤é»nR˜šßèLV•2„´:%2wÝü6Î*bòûÎ,ƒ÷Z~²0MËž¨Oy0…Ÿ9V›ºòÊéâ1mÃo^Z&eôFŽõ]7)LÏ!¿q’üÖ”³m;l%Ê~sâgIiÊ]IsœÊµ‡ØoF_íè¤é»nR˜šß¾“«¨ó ‡Uupi¿á“ÞúC ˆ)û{ÖÖ‰^IÁiòÙåDìÓ€Tlå*Ó1Aÿ÷kv¡Þ5ñâÅh—Ñ9Öwݤ0=‡üÆéÎo[øŽËIÊá•i€˜0È¥`‰ w –xµs—ÑIÓwݤ05;¿Ñû] @mW«SR0$f @Æê¸eSH˜’*¿Fm~¬0M¼DF¤ËÂT™FˆI¾Ü!¦kŠe½‘c}×M ÓsÈoœ%¿ÁV ²UÖYœBÁ²2 “ n\ˆIèŽüƓѮ¢7’¦ïºIajv~³&ñ/^b\íüö9ÕöŽ ƒ­à«ßœÁÊ"‘|pÁõõLä˜Õgû…l#Ί«LÄ$—¡îûS9¼¦X–Ñ9Öwݤ0=‡üÆé—jïM D¬æÊ¦þjÆ®Jz!&Jw÷˜èšbYF¯“fàºGa¢fç·ß0–ê˜6­žÊ€ùì7xc^å˜ìaJ¶/A4ð¹a××3Î1õñ~bÄ’.(MÄ$’ß³ S¼»]@ñ«½‘c}×= =‡ü¦iÙ“ì÷=l»Äйr•©¿š±j¸&ñ"¹ÙÿÓ¥eRFo$Mßu“ÂÔìüv&‰2¡#˜k‡;™4¾ûSa>:¡xUÁÒÅaün¡•qâOnåh–ü–œ»ƒ†v  ¿+Ó1¹Ð×…˜DïÚèd´«èë»nR˜žC~Ólç·­é”%eo}-:¿+Ó1Ù»ô˜B¼+Lg;w½‘4}×M S³óÛÊ‘¤ V_ ¾P\)LÇ,ñ½°2/w~³K~ÛÂÏ~[î“[9šx Þ yhÀ„r¨ji &ä÷‡ÉïxLº¦X–Ñ9Öwݤ0=‡ü¦iÍïl«$¶Õ5í•i€˜ÌëÍ1Ýnå.!ï2z#iú®›¦fçwô«n’úšU²‚˜8ûue×íf×S\T°ôµ? €^¢ØŸ*LÓßVš}j)ˆmn"¦Ê4@Løjª<ß’ßtµs—Ñ9Öwݤ0=‡ü¦Iò[sÊQûÅýT¨ V¦b²uú˜à¶ó›ÒW;z#iú®›¦¶æw&ï""û32½©·©¤9«š4ÿ@ãø`­Òü®ÓoµiF—÷7…i–üŽxtí'?¼(®=U¦b‚®*϶—»Cå'£]EoäXßu“Âôò›fÉo0äÏ®ÂVmåJÓ1ÅÀW‰-lz³šñÉhWÑ뤸îQ˜¸Ùù Qžàtí¡m¶‚˜½G"†ä:s«}Lö°6„l•|<_ü…‰gÉoôsÆ, åâW™FˆÉUß/Ž ñ•óÉhWÑ9ÖwÝ£0ñsÈož%¿}UðfÀPœ˜Ô¦b øV°û‚o,ùd´«è¤é»nR˜šßàgb~«$‰U]DL} ¯€:Á»ÚÇdkòÉ‚.ÖÿIÄÄóßÞˆ¦ÈœËiÏ•i€˜B€÷´g¼UIåw;w½‘c}×M ÓsÈož%¿ƒžÐ` …Æ’˜,MýÕŒrÄ뮜m¹â 1É'£]Eo$Mßu“ÂÔìü-„>ÚõèEZELÙ7d™³RËv—ˆ)G† ÑþEÆÕo ÓlçwŽÑûc½}"í•i€˜ ¦½9&‚»>Û¹«èë»nR˜žC~ó´ì‰áCüɉß•©¿šù ½öowsåùÒ2)£7’¦ïºIajv~CFôû$¶ª|ËTM%Óe ËèsÎd|·@Lö0Å”Žq¼ŸEL³ä·}mhËåô“.¨M#ÄdPôBLà†Çä“Ñ®¢7r¬ïºIazùÍÓšß’89ÂRÊžT¦bbÄëTÎßÜüæKÈ»ŒÞHš¾ë&…©Ùù¶åp}c\Y^å˜RÌ® Ķ7Æ1MT &{˜P].‰Ã¸mü7…iZö„íCàHÊkOµ©Ÿc>ž!_ˆ)ò!_Z&eôFŽõ]7)LÏ!¿yZó;ø•*§4²²'•i€˜8¿õ˜@C¸ALr y—Ñ뤸îQ˜¤Ùùm¿­Ë XMŠœ– “ƒž€ ²Qcâ¥ÂôzاÑQ΢úÉK™îüæ ®ä’}Gþ³0U¦~Ž%º“%Cºéü–«»ŒÞȱ¾ë…IžC~Ë,ù Jöe§”ĕ닻r…i€˜PõšÁýQ®ÀW;z#iú®›¦¶æw$Œ¼›—¶rÇ_L®.€®BI«šßö0 ˆ1~r+'³ä·«(Qöô. Se &Ð7b¢LùæäWNF»ŠÞȱ¾ë&…é9ä·Ì’ßh;Fö1¤e»@e ¦Èð>•£S ¨‘4'£]Eo$Mßu“ÂÔÖüŽœÑ~q€˜®ö1Ùò)ªU´ÿ=“÷}ÃZ’>Š˜¦^&®Æ’•Š­\e &K¬ôFLÀ7,rM±,£7r¬ïºIazù-³ä7KP°™\p±ä˜ S5C{¯»r~Z~‡˜ä«½‘4}×M S³óÛ'»‘ ˈI ¹¨¢Ÿ¯®"&1„I~'•ÂG¯¤È4ùmpÄÿ 8¦ þ$¿KÓ1Ù¦þR x£’*£]FoäXßu“Âôò[&Éïì ÕàÇÓ!²'µ©¿š¡A„7bÂ[ÙSy1ÚuôFÒô]7)LÍÎoH‰ÙöabJºt‰×AOŒB~[.rÏ(“|ÉìÔÜ',eZö$£ú7Ë–Ê4˜öì·¢/Ääs79vi™”Ñ9Öwݤ0=‡ü–YòX ¼Þ[¹Ò4@Lé%ur ¦£G»™4z2ÚUô:i®{&mw~[uˆ—"@æ¥K¼¯R .÷f  ­¦×ÃQÀu}mãûIŽIgÉoo¨’íãЕצ~Ž)§·‚ñ«u •c'£]EoäXßu¤Ï!¿ušü¶¯Ãñk ™K¡¸Ò4@LŠïsq°×ã®0]Œv½‘4}×M S»ó;û«`›*ûÕßRèSIc ''òNdVàÕÎo{8Šýô@4Ñõ›Â4M~ )z—›íK‹á•i„˜ ^½rD‰oxL½í2z#Çú®›¦çß:M~Û~¼U¼ï'b*MÄdßèµÿ«Œw«ÙÅh—ÑIÓwݤ0µ5¿mû †[ÚfLõ˜ìAƒŸÞMªÎÊ®!¦ãa j¯Xùhaš%¿™‰™Ô¥þ~¦Ê4@Lä¢$'b"¹»’¢'£]EoäXßu“Âôò[gÉï“}ÊÙ¾~¦Ê4@L„á:~‚ä1Œv½‘4}×M S[ó;ø|7–NâÙèó©Â4K~ÀöeŸYþ£0U¦bòá3bŒ7“žŒv½‘c}×M ÓsÈoîüöîdIÙðH1%µ6SÔ÷]¹Àw –zµs—ÑIÓwݤ0Ýu~ÛÞ ùü%ûõW;¿sfûÁ{3Ã2Çd0¸.ÓG'ñêlç·Á•r´-æOùæÚ4š]hòR°ÈŠ7,š¿ÚÑ9Öwݤ0=‡üÖéÎo#‚` ?@¡ù]™Fˆ)é›còñ\í¤IW;w½Nšë…)µ;¿£ý ‰­ë²Œ˜”)úø%„ÕÎïãaŸ-Õ>¯a¯Á/ Sš%¿]eAÄ9/(9¦Ê4˜Äãòœ—æ—í›>¦t2ÚUôFŽõ]÷(Lé9äwšx)É{ÉVŒB’¢6 ~ïÿc~uè¶’æšbYFo$Mßu“ÂÔîü~Î 5‰¦µ+)Mô˜îl#¸Øù}<Œ.Ë”ó',Ó,ùMÙoür P. Se &¤w“ëÊÜÜ•KøÕŽÞȱ¾ë&…é9äwš%¿%²åpÊÉ›j¦Ê4@Lˆïsñh[¯=¦t2ÚUôFÒô]7)LÍÎoÈIùèß>¤ÇV“‚ä¬Gß*)“=¬V×¼Ó2|²Á2M“ßYØwh:í•i€˜¬æ^„ÊÙßȱ‹Ñ.£7r¬ïºIazù¦^"@v¹E-ô˜*Ó1ÅwçwtÜ›¤¹¦X–ÑIÓwݤ0Ýt~»è¦DIdåi±ósJh¯ù%àUÄä+dáÈôÉË4ÝùVe"Ùû_Ü•«L•T«ôoÄävnrìjç.£7r¬ïºIazù¦Éo$ ‚*¶r•i€˜@ßÇO1½!&ÓÅh—ÑIÓwݤ05;¿1H¶íœK‰ê¢´®ƒB†3üYEL>·Ñêš·Òý¦0Í’ßàÃ1ÐÖ–Pò˜µi ’*9_„ý}wÒ:éd´«èë»nR˜žC~§é—ä£!l·$öý,L•iˆ˜~#¦»®Ü|M±,£×I3pÝ£0åfç7ºf‰ßïÏ‘ãÚø¦£Ù‚mç‚JVa5¿‡“m Y$À'Oåò,ùíU¨¤Ä9”…©4 a¸N~}àÅMKJ>í*z#Çú®{¦üò;O¼´=p„œ¸˜+_›F“z#&–›­\¾¦X–ÑIÓwݤ05;¿í­‰àÃì¸x*³Šã%¿Ⱥ:WÎæàŒŸh>ü›Â4Ýù­Q£·¶A,¯¤T¦b²$¸à'ÂŽ)_íÜeôFŽõ]7)LÏ!¿ótç7§¬ ”•,+Ó1ÙúþFLp×c’¯vî2z#iú®›¦vç7åCì-e+Ç«ˆI2D+kh›WYFLö0PtuôÑS¹‰XH¹”=)MCŽI¾S›>¦|i™”ÑIÓwݤ0µ;¿Å/åO‹ÅïÊX²*o•E1,ê1ZB«‡9}òJJž%¿mKêWk”3•zL•i ùepð:â„ü’måØÉhWÑ9Öwݤ0=‡üÎ³ä·Ø®Ú‡#%—û/¶r¥i€˜@B¼SÊw,óÉhWÑIÓwݤ0µ;¿}fe{‚ì^DL12°O‚«¡-"&˜‚$WJŸÔüÎÓ/•0ûÅ=Ÿ ü3Ç*Ó@%ÕÕ®ÛévÚs¾¦X–Ñ9Öwݤ0=‡üΓä·&¶Ý5‚­ê¡ÜÿW¦bòã³ 1¹®{3ib_íèUÒŒ\·(L±þêÄäüsÒ` Ò9èEÄ\".“ðÄn¬@Lþ0€¨Š==”&ø÷¦óëçX²/ÎöIŒ®´PœüV¦Ñì ߈InÈïâW;z#Çú®[¦C~ŸŸ÷DÒX9‰’|ÒP•4•©¿š97ý>•S¤ö©\ W;w½‘4}×M S»ó;%C9’†¸ÚÇ„(Ù;YôÕ¹‚˜üaí¼à·rç×3Î1UWEÃ:B±èü®LŽ)€\Óž!Ÿ]ñ»¦X–Ñ9Öwݤ0=†ü>?ïqÒ$H~Lš²ýVså S5³—®‘³ÑÞ»Ât2ÚUôFÒô]7)LmÍoÕ¤…=ÉÕÎod>´ ò,Ië^ ùHYø$Çt~=ãSAŸû™|(1ê•iÄ1 ~#¦ûÅïd´«èë»nR˜C~ŸŸ÷8iM\Å5åòT®4 “½D—‚e¾xÃÕÎ]Fo$Mßu“ÂÔîü–ÄQ¢¸åR»€ƒ1¸•“JºV“=,Ù^a–øÉ>¦óë瘪‚?ÛYF*'ñV¦Ǥñ=‰'iº£ NF»ŠÞȱ¾ë&…é1ä÷ùy“&"Ù®!så*Ó1©¼¡A”€í“NF»ŠÞHš¾ë&…©Ýù-¬Ùtô¡—‹ˆ‰ìWŸ0nÿ,_Ûî×µ‹ÒG Ólç·ã]+Ó„‹kOµi€˜|‘ºSâ[Žél箢7r¬ïºIaz ù}~Þã¤9†IÚÌ›fBcàåÓ1ɧrLp³ãS,D¯“fàºGaŠíÎoïAB¿J›™eU]€2€²ÏW±Â¶Ê1ùÃdÏ#ù@­¦8K~C dZ\ð¿¸Y™Fˆ‰Ó{O½)Lñd´«èë»îQ˜âsÈï8I~«‹B›oÌ+V³Ò4@L”Â¥`i+¶%)b„¯vôFÒô]7)LíÎïìøD@V,E#‘f0ÌpqJÊëá(.÷ÇÕo Ó$ùmi¶?J.[[JëT¦Ñ©¿'ñBNñ®0áW;z#Çú®›¦çßq–ü&Á3ú¨¡Th~W¦bý¾+‡ñf|SŒ'£]Eo$Mßu“ÂÔîüÎÑEGˆU]„d1©ÏF[ªãV¤1ùÃVÖÄ ó'Éï8M~Çc¦JHZMâ­L£S¹À*÷é3w¨üb´Ëèë»nR˜žC~ÇYò[!z ­ÉÌ®LÄä·Ã.Ä)Ü%ÍÉhWÑIÓwݤ0µ;¿ âYºKH!®žÊ GïBÊh[ \U°<öNƒŒaÜkð›Â4K~û ×ù'Ã8?SmpLšÞmôbºCåúÕŽÞȱ¾ë&…é9äwœxéB¬)sV¤Ÿ]¹µi„˜ß“ÏU»IškŠe½‘4}×M S»ó›2â,diDøAI¶ÿ Éçv¬žÊÙÃ)“÷~ç×Uü¦iÍoÛƒ‡ä-V?oԦDŽù}ò œÃ]aº„¼Ëèë»nR˜žC~ÇIò;G¶¯þ¤Ÿíµi„˜”¯ÛÊ݌։ðb´ëèuÒ \÷(LÐîü{ƒìw&{}¢.&oEJÁÃAÅåOVû˜ìa+‡.P'ŸœÄ{~=ãÓ˜¼WÔ€cJ¹@L•i€˜¬v¼uå)ÐMK œZ&UôFŽõ]÷(Lðòf;¿Ùµ!cIX*XV¦bÂÞê˜îöÿp¶sWÑIÓwݤ0µ;¿£‹GSû^ÓÒ—ú˜lÝ9ÛþÕåœVû˜ì?9DNBé“ÃίgœcJè ÕKò»6¦=KºÔl!¼áò.£7r¬ïºIazù ³ä·ßŽÕàÇÚKŠÂTšF§rÞê˜ô®0Œv½‘4}×M S»ó;øExÁ[Wû˜0xRf²Ík^j8¶ÝFM”=9¿žqŽiöÓ.ɉIÊËÊ4šöò»óÛÇçÜäØÉhWÑ9Öwݤ0=‡ü†éÎïÄH9!WzL¥i„˜8ç7b’»Îo¸Ú¹Ëè¤é»nR˜n4¿ "ª½<>‚i¹ó›mæ#VlK¾&{r>Œ†ÔüÅ•O6XÂtç·­+l`çÐÔúY˜*Ó1IÎ×É/̹éü†«»ŒÞȱ¾ë&…é9ä7Ìv~GA×Yôe-¦¤T¦bBˆïS9Ÿåt“4g;w½‘4}×M Óæ7ÙVÊöaWeO{^âĶs²F~ŸKYu ·~S˜¦eOì“ðó4NP¢òÊ4@L®æòFLBw[¹KˤŒÞȱ¾ë&…é9ä7Lw~û‚îËEŒ\iå¦bŠ—ê¾ŸÊÉSÄ«»Œ^'ÍÀu„íÎo3°€}&¨«zLLÁ`b¶ÏtuïñpL‰liPý$ù³ä·!¿l¡Þ\UHëT¦bÒ—’Ë‹c 7#Â"žŒv½‘c}×= >‡üÆYòÛ–s[bíõÉ¡FPšˆ)Ú[øîcÂt³ÿGøjGo$Mßu“ÂÔìüös1ð+°6"ÜÂ):^2Ø“C^U°ô‡#ÙÊàJqŸä˜p¶óÛ²‘ ’äì÷tŠÅ¯4¨¼¤Ä„g;w½‘c}×M ÓsÈoœ–=‰™JDÁ‚˜¬MÄäÝ•­ŽÜ%Í¥eRFo$Mßu“ÂÔîü¶?€¬ª$µ2!«SR$¥h›@r­—¸Ô`y>¢“¹Ÿ,L³ä·ß÷ˆ¶½L9#ÂjÓˆcJá}*gÛ®›ÛÈ_íèë»nR˜žC~ã¼ì‰Cc%Ʋó»2õW³˜_RÑ^ªŽ ßZ&EôFÒô]7)LíÎïù7^=•Sñ oɧÂNˆPˆéx8·¾ø³ˆiZóÛÞwÅ0K©.P™Fˆ‰â÷©Ò]p y—Ñ9Öwݤ0=‡üÆiò;“¡X ~_ÂìÒÔ_Í|úî7bŠwG¹x1ÚeôFÒô]7)LíÎoÀÈLHȲ®Ç”Ž£í`óÚVî|X\öÛ‡ôQÄ4Ûùjù(öAH€â¢xe!¦ß –®l“cg;w½‘c}×M ÓsÈoœ%¿m}ð‹è‘‚H±•«LÄ”ò·“A⛤¡ðÕŽ^'ÍÀuÂD7ß, ]"€ÖÈo=Y™léÎD9®rLþ°Ú;›1|Ró›fÉo¶Á>²Wž‹ÂT™ˆ‰þPIÍùN(ŽNF»ŠÞȱ¾ë…‰žC~Ó,ù Þʇ 9%,ÈïÊ4@LéÎïäF(ŽNF»ŠÞHš¾ë&…©Ýùí q C@Q€¥ñMzä°Ììa•c²‡#øHõ+sŸ,LÓšßæ ^.‘‹vÚ4š]ÈzqLÑ{½nrìò.£7r¬ïºIazùM³ä·aX±7^’ßdøY˜*Ó1AzOI îV³“Ñ®¢7’¦ïºIajw~"Øïm;PÅå))VÕ£SçÑ礬j~§cý'ûØ>Y˜¦;¿1û¥f{ó ò»2fâ7*On.ñÒÕÎ]FoäXßu“Âôò›fÉo ä÷±êcªLĤß]¹1¼”ZIs2ÚUôFÒô]7)L7šß`»0HÑO“}’½ÝÀ‡eê"b²‡mÉ“àø¢Ýo Ó,ùù;Ÿ(Ø6³(L¥i4»¿5¿RÆ›kOt2ÚUôFŽõ]7)LÏ!¿išü¶6¨Ï1‹¥º`e &×´9ßÀì#BüßIs1ÚeôFÒô]7)LíÎïä S´,·’ª‹“xÑ_zÛ‹1iXœ+w<¬ lø’ô£[¹Yò›Å6]>)=–b„µi„˜Xÿ˜öŒw¨üd´«èë»nR˜žC~Ó4ùí*Ç$Y2sQ˜*Ó1‰œ"^ý[f8„…‰/F»Œ^'ÍÀuÂÄíÎï‘È1KZœ+‡!eWà°‡ýòÖb:> lqÃû,¿(Løìû¿|¼Š˜rˆÇ´*ˆ‹såüaW >æ |²0Mw~ÛæR,%³B!­S›FÓžõ[óK4Ý4ñòÕÎ]FoäXßu“Âôò›gÉo"×­§äjì?%)jÓ1ÙR}¾‰ÏiuÒÈÉhWÑ뤸îQ˜¤ÝùÍj‹°aÈ„VVû˜Ð¯§r`‰.ý½ØÇä[5K~ôÍ0ì5øEa’YòÛ0œ²wî«•ÌŸ…©2¦=_ –~Øä†c’“Ñ®¢7r¬ïºGa’çß2-{BG“p&&Êea*L#Žé·6Ää÷1n Ó¥eRFo$Mßu“ÂÔîü¶Ø`Kˆˆp]ˆ_@L @†–aPÈ9O ¥ûMaš%¿lEaH.çÊ•¦Ñ´g€k¯Q½é•““Ñ®¢7r¬ïºIazù-“ä·º +y‡½ÿÅjV™ˆÉ Íuü”(ÓM“ÐW;z#iú®›¦vç·•%׸Í9¬*X"ÔÊI²²žYå˜üÇÚNèòþ¦0Í’ßLwc8æ+§r•i€˜¬~¼9&+L7}Lr2ÚUôFŽõ]7)LÏ!¿eºóÛEp]ïAÎüªM#Ž ¾“ál½)LW;w½‘4}×M S»ó\¦|¬«÷/"&C=VÑRR¡E¡¸ãa?˜³Ÿó'Ûd–üæ@ìªÈ) ” –¥i€˜ø¥ó} &ÕpS˜NF»ŠÞȱ¾ë&…é9ä·L“ßjk³Ÿ¹dbA~—¦bÂüž…­Yé¦]@.F»ŒÞHš¾ë&…éFóÛpR6°—(åµK¼^Õ|ò’¸Æ9è2Çäz¾‘ý:ª7Y~²0M¼ Ì.Zƒ.ù³0U¦Ñ$þVIµ…ð†ü–kŠe½‘c}×M ÓsÈo™%¿‘Á¾ ¾®—SRJÓ1Åx˜¤Àñ†cÒ“Ñ®¢×I3pÝ£0i³óÛÙçì“]£_Ã]EL>Ë‚½*1g^ELàïXbÛC2Ã'…ât–üÎÁ1/$LŠ­\eMâyÊ;gÂM»€Æ¯vôFŽõ]÷(Lúò[gÉoñfÌ >ñ‹S¹Ê4BLò¾ù­ªéæTNOF»ŠÞHš¾ë&…©­ù"eÀHd1¡+—%$Ö×tã%Ä„ö‰af×[ÉŸìcÒYÍïàGŒ¾ó’PJëT¦Ñ$äïI<|×Ǥ§w½‘c}×M ÓsÈoíüöI÷Œ‡p}*ÛJÓ1Ù&âêc:tpo ÓÙÎ]Eo$Mßu“ÂÔìüÍÙ‡»$Å(¸z*‚ªÞÅäíÈ‹zLþp¶rhu1²IgÉoÁ4¹L‰”så*Ó1~Ï.¤»>&=í*z#Çú®›¦çß:K~'VWþ ~»íGaªL#Äô=%Õß§ŽIOF»ŠÞHš¾ë&…©Ùù ’1h¢äZè«}L.oOÛ†ŽÆ»±²)…(¶ôÛ&ühašÖüΆüĹ6ïøüY˜JÓ1Aä«[5Bâò[/!ï2z#Çú®›¦çß:K~c$\“íÅ/GëT¦b²WâBL†nî8¦“Ñ®¢7’¦ïºIajv~û\½”À9h†µázÀ¥Þ³úüÅUÄäã]+8¥ ~S˜¦eO¼ëÁ¾:%Wìþy*WšF³ ¿û˜@îú˜ôÒ2)£7r¬ïºIazù­ ²'š$øòZ"¦Ê4@L®p}!&?Ûo¦ô­eò3z4×= Sjv~©!¼Ì®pqµÉ^?)£Øæx|Ý­BL¶í H‚Hã#½_¦4K~k ö;©&«ÕE¯\e ¦ó›c²ê}S˜RüjGoäXßu”žC~§éÎïãòDD¶—¾ä˜JÓ1A~ïÿÕÛžo ÓÕÎ]Fo$Mßu“ÂÔìü?èÏöëjH«zL10¸l‰æ1MTÝ•#‚A(ùdƒeš–=1çYŒ®qZ\/LÃÙ…§N±OâÉw§réÒ2)£7r¬ïºIazùfÉoŒNÝäœl-ú˜*Ó1)^êj/æ]a¢¯vôFÒô]7)LÍÎoð!É¥q5Ç5òû¥l ‰${Ã/Éž¼&Ûúf ¶öòT.Mk~#g0i*;¿+Ó1azë1Å—Jj«0]BÞeôFŽõ]7)LÏ!¿Ótç·2Ú‰\еà˜*Ó1A¾V3É·Òºéjç.£7’¦ïºIajv~C$ö¹n˜]}$,"&«)è£N’¸DÀjç·íIlû˜]Ý÷£“xӴ쉕iÛ‡ï')Nå*Ó1]æ1í9Ü!¦KˤŒÞȱ¾ë&…é9äwšÖü`;²½uÙcR™ˆ)f¹Þ@W¤¸!¿Ó%ä]Fo$Mßu“ÂÔìü† 1+GIiµÉVï`xIíïÆ¼ÚùíK?±C&û>y*—fÉoI.(ÂYŽyR?OåJÓ1!~#¦»S¹”¿ÚÑ9Öwݤ0=‡üNÓ²'–ü9$¢,\ß•i€˜"Ë5WÎVú»Îï|i™”Ñ뤸îQ˜r»ó;„”6IJyM(ÎAQ @â—ÞÃùýzí«°]–Žoʳä7ٯĘlO›Ry%¥4¦='yŸÊEÒ›>¦¿ÚÑ9ÖwÝ£0åçßy–üFqáZÈšl*8¦Ò4BLü²‚w…éd´«è¤é»nR˜šßöÆãwN¤qYóƒ ÛsÙŠÚê\9˜ÑÖ~ÛþâGÉï<-{"¶¶$ŸA¢\Êž”¦AŽ|÷1Ù?7êùÒ2)£7r¬ïºIazùgÉïÈ>v™‘½–[¹Ò4BLoމ^óÐZ…éd´«è¤é»nR˜šß1ùˆNt IȰ$wh¦§®s¶[’b3‚º¶—í“äwž%¿1©¡ÆÈ‡žçÏÂT™Fˆ)Â÷©Üíø¦|2ÚUôFŽõ]7)LÏ!¿ó,ù-`û$Ûs€J9‰·2SÄK]@lÙ¾+L'£]Eo$Mßu“ÂÔìüŽb©.>çÅ’}õTŽT,PÊK/_§l©ð“}Ly’üNÉO0Ð>JiÒ4œö N{¾!¿³~µ£7r¬ïºIazùgÉoo—< å$ÞÒ4XÍ‚¾OLÄêÒ]a:í*z#iú®›¦fç·-½à¾™ÁÅ$W“½'Ù¯áØ[—Oå|Òe j•‘?:ð2Ow~§ìämi)§r•ic¶H}O{Ö[Ätµs—Ñ9Öwݤ0=‡üγä·&—¬5ÉRß•i°šz+Xr†Ž ÂÉhWÑ«¤¹nQ˜ þêâëÈ(JrÀ ºÚù!bàlÛaCLK…éõ0{'‹ÆONI9¿žqŽirÅZ4¸ëS<¦Ê4šö¬ß}L¨}*ád´«èë»nQ˜ <†ü>?ïqÒ$wU?„û^ Ž©4¾, âhû¯}ý_íè¤é»nR˜šßñ˜¬Bäù%×vó…¶SŽ>ÁÈ6„ãy%bÊíIÛHfÆ#8¿ž‰Ã(®ñío¡âvAe䘦ô˜î„â àW;z#Çú®›¦Çßçç=“4ê'–…©2õW3¿‰çÈþbܦ«»ŒÞHš¾ë&…©ÙùÍN]Û†C>€äta2ÐÆ˜H8¹²®.]Iy=,Áª¢"òxZæo Ó´ìI¤do½ýÃE¯\mqL‘õ˜ˆÚ„KˤŒÞȱ¾ë&…é1ä÷ùy“ƇŪ÷¼:Rß•©¿šÙnë Süí`ÄÔæ˜ ÈW;z#iú®›¦vç7Š&FIjoÒqSg1‘j>JˆÙ²5ÄäÜwVßõfcü`ašíü†D‡2•!j-¶r•i„˜”Ò7bzuÅ7rìl箢7r¬ïºIaz ù}~Þã¤I®)ɪSy*W™ˆ sÊbÂÀí»r–L_íè¤é»nR˜Úä7p²âÛŸ— “BÉìyIxíïñ°‚O('òÉáç×3Î1õ‹9®pб˜ö\™FðÕF­’ ájç.£7r¬ïºIaz ù}~Þã¤I(àÖçŪÁ²0 SÆ 1…Û –/!ï2z4×= Sl’ß” ¡¿ªM´„˜Ð{+Ñwdq|â_"&´§™2{ç' Sœîü–èP}»}L•i€˜$Ç«óÛöÉ7“x ^íÜeôFŽõ]÷(Lñ9äwœ%¿ùà©9‹ÏˆøY˜*S5K)å‹Lácû/ēѮ¢7’¦ïºIaj“ßÁ‡”P”cï*bBö0ˆ¡&I«}Lö0F\ g~pÁùõŒsLmSëC…%yCúÏÂT™ˆI ^R Ù Í]Ž]Z&eôFŽõ]7)LÏ!¿ã,ùíºàh ) Siê¯fIC¾å 7[¹x2ÚUôFÒô]7)LMòÛê²A öÿ¼¥ÐNåP\ä €¬<-Ië¾QL¤Ÿä˜â,ù Þ. êôrI~W¦Ñ´çô¾™]Úí&ÇNF»ŠÞȱ¾ë&…é9äwœ–=ɘli'çË‹á•i€˜ìe¸Nå(#ÝœÊÅKˤŒÞHš¾ë&…©I~GÊäJ-¶£ÅÅaÇ0ÝÀ¶´‡hY‰í…~ñ+EúèVn–üöö fÛ…a‰ÊkÓ11¤«óÛòí¦‰âÉhWÑ9Öwݤ0=‡üŽÓšß"ÞˆÿRÊ(9¦Â4@L¢Y/Ä”ÒÍ]9ˆ—w½‘4}×M SSöÄõ€ óÔÛè"bŠbë6qPö™z« –¶û«å>Ã;}°óûüzÆ9¦öǨO‹±O$²'•i4»ð%urÌ.$¾;ù'£]EoäXßu“Âôò;N“ßÉ7Ibo¤’ü.MÄDÞˆIñf|ÀÅh—Ñ뤸îQ˜ -{>E9«áYÖü¶‡€mÛâ# VÕü"j¶Ÿïãùâ¿(L0M~§1†1ÅBZ·2 I¸Nål½Êw9v1ÚeôFŽõ]÷(Lðò¦;¿³­Î¶KœS¡`Y™ˆ ½göDLôæ(®vî2z#iú®›¦¦ì‰í§À6½p1ùAª•ð?z1Å`;ß”"|´0M“ß‚V¢ÁÖ–RÁ²4ð¥.àú7ä7\Œv½‘c}×M ÓsÈo˜x(e'j ùY˜*Ó1…tň‰1ßpLpM±,£7’¦ïºIaºx)–é>à›ßJóˆÉé%ôqÕ|"¬ &{Øv¼öñILúÉ+)0Ýù2ßP´¡êŸ…©2S€k_œÂ9«‘cW;w½‘c}×M ÓsÈo˜&¿Ó!NɹĂü.MýÕLsÔ7b"â;Ät1ÚeôFÒô]7)LMÙÛ{¦ìºÓ·¶ÙdÒ8Aä[ b!ÑEÄäkWʯ•âc…išü²_Êv–‘Š‹âµi4»0áuÓòo.ŠÃÅh—Ñ9Öwݤ0=‡ü†Yò›ƒßB‹öåPœÊU¦þj¦‰Ž“1Qw…éd´«è¤é»nR˜šßxÜÂõAÝq­]à€[`/mU\žwq¯?Ì¢VÒÈ6×Ãùâ¿)L³ä·+Cø ûH¸ØÊU¦Ñ´g ëˆSYï,àd´«èë»nR˜žC~Ã<ù­êÇ€ZHRÔ¦bJ¯£í1a¾».€oF»ˆ^'ÍÀu„ÍÎo$ JJ ~-eq/È1°*Kˆ¶-Ö–1‰_”C˜êß ΒßÂ"¡mC^Jë–¦Ñ$Ûq]ˆÉµ:orìd´«èë»îQ˜ð9ä7Î’ß΄HŽK¡¸Ê4@LõÍ1!¼fÌ7’æd´«è¤é»nR˜šß(¾9°‚Ð9Éj1qˆ9sÎÞ^ KíÇÃà/í]Ë0V™ûMaš%¿S²úì||Hò³%¥6f~ÏÂò~ÞŽ OF»ŠÞȱ¾ë&…é9ä7N“ßùR8º8 ò»4 “„ƒð>“­Ûwˆéb´Ëè¤é»nR˜šßÇ%u®Ñ÷c‹ˆ‰œ`²¿_Õ b²‡íÓb?Êüdƒ%N’ß)"ÛGa“í’Ê‹â¥i<»ðº+§!¦»Å¿ÚÑ9Öwݤ0=‡üÆYò›œÈ!ÿoQ˜JÓ1a|« PÈéæ(OF»ŠÞHš¾ë&…©Ùùm¿2#Gñ^bÀ%òÛ5S²+~+ø®5iÝãaˆLÑÀšÁ‹"¦YÍï•\Q$¸~ÍÏ«L#ÄtnßÄD|—c§w½‘c}×M ÓsÈoœ×ü¦ˆö øÆ£à˜*Ó1N—“Ÿíß´ à[È»ˆÞHš¾ë&…©ÙùM#eò.޽ˆ˜â1ä3&¶ÍÅ"b²‡Yí󲉎'ü¦0Í’ßYé­UûÕ Ž©2ax#¦¤7 –x2ÚUôFŽõ]7)LÏ!¿q–ü†ÄÑ28 [¹ÊÔ_ÍD_ÆG—Ÿ •µ“†ÂW;z4×= 5;¿I¼NM–̰z*çÛVÛ̹ðI’%¡¸×ÃÉ~ºÕòøj“þTa¢iò›œ.“Èh@º ¿KÓc¢ôÇtƒ˜èb´Ëèë»îQ˜è9ä7Í’ßBÌd™´$¿+S5þ>•CátsbB'£]Eo$Mßu“ÂÔìü¶]†QÛˆS=«§r!EßÙc\îc ü¼Š4}´ó›fÉoL˜ÀÕ~­h…©2f&¸8&?^¸Ë±“Ñ®¢7r¬ïºIazùM“ä·&Ì>M}–Gq©2 “wô½Á 1IôÕŽÞHš¾ë&…©ÙùMœ1qJ")-¶ ø¼Yï¶Pß,…´&­ë“¡%‰¶òÇ0–&øMašíüöF4Íà§«¡È±Ò4š]¨|!&Ë7¼+Lg;w½‘c}×M ÓsÈošÖüÆhþ!¸4`ALV¦b‚$ש²=w“4—w½‘4}×M S³ó›$FŸ (†Z-ª Ø_ ¶¡Hèïáê]9˜Á¾€œ(»3S˜f;¿m/›7D*©µi„˜DÞÓž]rê&ÇÎvî*z#Çú®›¦çß4K~iæüÈÅQne &[¦/ YôI_íè¤é»nR˜šßD~Á?°ÕSZ¼+#ô‘tÞ•´ˆ˜ìáä꺶òÇ8 ÿMašÖüfµ/˜Ä§Â –…i„˜ ½“þÙº„¼Ëèë»nR˜žC~Ó|ç7»úkfoª-Si &Û8Ð…˜PîÚøÝÎ]D¯“fàºGaâfç7 ±Ory¤EŽÉ‡øúˆñ€âwZ“•¤``"{gçGïÊñ4ùlUÉÉõ!Ë))•i„˜]wåôNÁ‚/F»ŒÞȱ¾ë…‰ŸC~ó,ùmË+ûJ$¨†¢0•¦þjƶѺô˜Ð$n’æd´«è¤é»nR˜šßäôP°Zj{ZE=&CZ¶§Ÿ>œû˜üa³)L)É',yZöÄ> ÛYºRp‘cµi4íùÕ×u ¦hŸÏMŽ]Z&eôFŽõ]7)LÏ!¿y¶ó[²Á~ƒ$b@¶à˜*S5óíùûT.æ;­>Û¹«è¤é»nR˜šß)SÌ.žoÑE=¦C$.Ùv܅Ǹ…¯‡³†¬>ôZÆ­¿)L³äwd5(’]†‹+)•i4í™ø=í9ߊòÉhWÑ9Öwݤ0=‡üæYò[svV‚¤(L¥i€˜\pñ˜äv5;í*z#iú®›¦vçwd[|}þRJßISIãŸd°r–ìmq)™…&(|=Ì ¬*>.ó£…i–üN.ä)œ] ¦¼+Wš³ ½xœ9ƬrÃ1±~µ£7r¬ïºIazùÍÓ²')¿·ïs‹­\e!¦×øRÄp—4—–I½‘4}×M S»óÛ6:ˆíCÑ¥K¼G{ªƒ˜\‡Ct¡ª½­)Ê!|f«Ãð'ÿ¦0M“ßd_¡ý2à|uÁ1•¦ÁìBy &˜ä¥YÜȱ‹Ñ.£7r¬ïºIazùͳ䷨±ÀB~TZ ¦Ò4@LJñÝùÏÁ„uÒÈÉhWÑ뤸îQ˜¤Ýùí[9eté’¥vczZÈ!GïbŠyᢾ¶Í£½³œ­< áÖ/ “̒ߪ™Ùñc"-,+ÓhÚs€KÁ‚ýÐò&ÇNF»ŠÞȱ¾ë…IžC~Ë,ù­VN²½D¶µæâoe!¦@ï»rñöJŠœŒv½‘4}×M S»ó2û­fßÞRXâ˜ü¦!†ÀÚ@h ×Ñ©¤±‡SÖ(¢Ñ…}q8ø7…i–üÎ.ˆcÅ%•§r•i +煮b ùn+'øÕŽÞȱ¾ë&…é9ä·Ì’ß~}á $²½? Se &CÃòFL(w…éd´«è¤é»nR˜Úßd›‚¶-ðëêqñJJtÅ2²'ѶKÓñ°_â±7Ø>´ñ„ߦYòûPlÏš}4p©`Yšˆ)H|#&+½7ír2ÚUôFŽõ]7)LÏ!¿eZö$zs}HI…´ne &–S(ÎñS¾[Í.-“2z#iú®›¦vç·+Û’+s¸ìêÀK×Ù#×Ö ®€²¶•CòÞJƒ¯ úMaš%¿Õ'¶X™´÷þgaªL£iÏ™¯£|ž*4rìd´«èë»nR˜žC~Ë$ù­>°Ž‘ÒÂeWni!&øVðq7I“¾ÚÑIÓwݤ0µ;¿ý¬žƒí¥À Ì¢ì ©­Ý£7$a\hôËö)oSàáÿ)LÓ/Õ¯`É®•ðóT®4¦=+\9F™o¿kŠe½‘c}×M ÓsÈo™%¿SR¿½¹œ’R™ˆ ®Õ Ή)¤Ñ“Ñ®¢×I3pÝ£0i»ó[bÇ4ÃŽ°(­kEÅvc¬)¹Çb»€¿ïŒ¶Ì!´I§^rö 7Ñ/cWà Ó1qÈoÄä3ÐorìšbYFoäXßu¤Ï!¿u’ü¶ä%ŸZ£¶+V³Ò4@Lç5”× !¥›K…¯vôFÒô]7)LíÎo%ðÙrl9&M˜b°ÚÆãôüL{ذ„º¦¦Onåtºó›}\9Ù÷…´NmM{ÎðžÄ£¯A ­»Ú¹Ëèë»nR˜žC~ë,ù¶BdoU‹öo?Se ¦¿“­õ7û¥¯vôFÒô]7)LíÎïŒÁ ‹íÒ Mäˆ)“J8î,{»@XCLö°aŽ®1÷RøXaš&¿‚¦ñj5"¼0¦=¿¤N^ÓžñîTN/F»ŒÞȱ¾ë&…é9ä·Î’ßÁ°q¶WÇU¢ iÝÊ4@L!é¥Ç)ò]ÒœŒv½‘4}×M S»óÛp‹Û2¡æ´z‰×¹~W¡~ëbQZ× È" q(æô›Â4-{â2Gœƒ•J,^V¦b‚$áBL¢wSRôÒ2)£7r¬ïºIazù­³ßâ_¯ä T ¦ÊÔ_Í(_ –>uñnÿ¶sWÑIÓwݤ0µ;¿åèÜfÌYÒ· –ÅÕ7üPDzÝEƒ¥=Œ>Á¶Ö„ŸF ³ä·sm 9¨-Wea*M£iÏø˜Hïšxõd´«èë»nR˜žC~ë´ì‰ƒãÄ‘±ÐcªLýÕŒüîè…˜”î¤uSøjG¯“fàºGaJíÎoÎÉõNÄo®&û‹I³O2ˆÁjS ˆÉ†è“|9¡~R)Mw~‹ë"ÉÅKmÍ.ü¾iXônDxºÚ¹Ëèë»îQ˜ÒsÈï4-{‚¶Uò+² ¡øÚ4@L†²ñBL’îÔÓ¥eRFo$Mßu“Ât£ùí¬¬FØ›D¸|%Åë‘áBi1‰ä®Æ ?:Œ Í’ß¶9’äbÁÞÿ³0U¦ÑìBÃ4bBÈ7òÍéd´«èë»nR˜žC~§iòûðÎ~~T¼¬LÄä(øBLBáfÿŸ.F»ŒÞHš¾ë&…é¦ó;ø^ïEJeOì/>È©D  CÙî1Ùþ,D.PðÉÂ4K~‹F2ÀkûñHù]™ˆ‰¯“_ûpâb:í*z#Çú®›¦çßiZóÛ\ 8p°õ¢(L¥i€˜ìuà 1qºÓÊI—w½‘4}×M S»óýH C†à³“á,Š>Ï€pIÁòõptÂ${u?9Œ M¼Tà‡„)Ò:•i€˜\IæBL1ß ¼L×Ë2z#Çú®›¦çßiZó;†‘lÁÈ¡º’R˜ˆ‰2_'&àýÇ7Is y—ÑIÓwݤ0Ýh~P¿áœ/ZDL]Ï*ç,.B½:ðÒ¶wVSöûhaš%¿1…€,j3}L•i€˜l«oÄîÈït2ÚUôFŽõ]7)LÏ!¿Ótç7Hò›NKså*Ó1Q¦7ÇDª7}Lùjç.£×I3pÝ£0åvç7dƒí*z#iú®›¦vç·ýΣ½<>w± ¬¦áDȯãñÄä:Œ¶óñ£é£íy¶ó[Ž©/1³R1Tµ6Ó%{âˆIø¦] ŸíÜUôFŽõ]7)LÏ!¿ótç·’½õmÃQˆxÕ¦bòÑ7bB ›£Ü|µs—ÑIÓwݤ0µ;¿I‚çlÛÅÙî1±÷}ûÆÕ€/žÊùÃì²3Âv“Ÿ,LÓšß9ø‰‚ëOü,L¥i€˜„Þ}LèÊ079v y—Ñ9Öwݤ0=‡üγä7ÅcÇqÈRåV¦b‰oÄô*RuÒ`_íèUÒŒ\·(LXu/ŽÉ6r¶EËöL« –~Í ˜¼‡QÒôˆI¼=S\AÓ§|®0_Ï8ÇTcôãIw[ŽoªLÄÄ€×ɯÕlh#& W;w½‘c}×- “ý’O)Lçç=Nš££cð%£ßT™ˆÉ߆ 1Áy¥¾‘4'£]Eo$Mßu“ÂÔîüF²¢$¶¯Âh›ƒEÄ”íÓ4èC~3z1ÙÃÑ/´€d‘"¦óë瘒¿ì’3x‹ÕÏÂT™ˆ‰¯Åï¯Gaj7ñb8Û¹«èë»nR˜C~ŸŸ÷8i µD®dOJÓ1…„—æ·íênn~c¸Ú¹Ëè¤é»nR˜ÚßÑrœ)ÛÖ@qE¹ä@L)—¯´ê¦²|*—üf%9ÆÚ}pïùõŒsLÙùríó ?s¬6 "]<&2a›ü¶lùjGoäXßu“Âôòûü¼ÇIãw\~Ý5µ¥$¿KÓ1ù`7bj7¿a¸í2z#iú®›¦vçw@!ññM/aÏÄ”Ñ'Â8{Íé8…ZALö°H´­dþäˆðóë瘺0¤÷²ÇLPIë¦bŠ–b"¼¹’‚ášbYFoäXßu“Âôòûü¼ÇIãzf¶Ä’2§‚ü®LýÕ sÊo=¦˜CûTÃÉhWÑIÓwݤ05;¿ äùU7{¬@¤EÄäøbÌVÖ|€Óbò‡Á9w«N>¨.p~=ãSÑà_žfÛ눩2 S$~ëÊ“kM´sìb´Ëèë»nR˜C~ŸŸ÷8i’kGØ!Åüó‚emê¯f~õæ˜"ÝLâÅxi™”Ñ뤸îQ˜b³ó5ØGàÍ•ö›/OI‰¾¡ˆjË‹fXä˜ìaûœ‚mã|xñ¯¤œ_Ï8Ç”Ä*4ûL¤,L•i€˜œž¾êÝV.^BÞeôFŽõ]÷(Lñ9äwœ—=1ÔŸm¡Û…©4 “¤|#&¼é11øýÕŽÞHš¾ë&…©ÙùD”Bæ^j°+ˆ)Jô«%‰_#±W“=Œ™ÉÊ!‰~°éüz&r \+O1ûÚR6ñ–¦JªAb‚t£Ç„ñjç.£7r¬ïºIazùgÉou–ÖJÚú^¦Ê4@LúšZq ¦€Ð¾Ä‹ñd´«è¤é»nR˜šß̈¶+€`%b©09è±W$²"¥Òùýz8•&ZÃELÓ²'É>[+y{äÏ­\ièʧëÚ“ý¡ ·¨üÒ2)£7r¬ïºIazùgÉo[Ï%‘d%ÇTšˆIczsL†‰ï ÓÉhWÑIÓwݤ05;¿1 Ÿ¤äSuÓâ\9{åâ1=Ú)‹ˆÉf ö£“ýë'û˜â4ùû1!ÚÆ¶$¿KÓ1iÎïiÏÇ•îvŽ]Œv½‘c}×M ÓsÈï8;ð2+£ ÚâšSq] 2 “D½8¦˜Ó݉I<§XVÑIÓwݤ05;¿!óѯî£xm#ºˆ˜ˆ"ELÑg}."&{8¢A¶1ÜúMašÖüöÖªˆââuESe!& ¦p‡˜.!ï2z#Çú®›¦çßq–ü†”X£ëÀfù)_›ˆ‰r¼ºrcŽñæTNF»Š^'ÍÀuÂÍÎoPÕ ÂV%Ç¥Âä:Q\Z ú8!^ìcò‡­$ù™žËž}°0Á,ùmÛ$7–˜¨@L•i„˜ßêðj>måXüjGoäXßuÂÏ!¿ašüVOdbPÊ%ù]šˆ‰‚^'&1 Ýlåàb´Ëè¤é»nR˜šßÀ¶Ã¤dX/ò¢‚%r&ƒˆšRÔ—Èï×ÃÁAŽð¦iÍoïB÷ y”Ê¡ª•i€˜ÎÉ/2Ã]Ž]BÞeôFŽõ]7)LÏ!¿a–ü&Q͆Hb†òT®2 “U¦ëÄÄPŽÞ!¦“Ñ®¢7’¦ïºIajv~û±ZÊ!Ø º¶•;n¡ÿ­9kš8X+“_!‹Ù屯º¼¿)LÓ²'Þo h»[)fÖ¦b²:ÿ昂æ›v¸´LÊèë»nR˜žC~Ã$ù­>{DƒiG EÒ”¦b~OIñq87í _íè¤é»nR˜šßà³½­²0‡WïÊaâía ~›w1Ù¶7Yq ‘˜ã'Û`–üF äC…Õv¨Å0‚Ê4BL$ôFLx»•;í*z#Çú®›¦çß0ÛùmÉk[ ±ïDbÁ1U¦bŠüž`ÏÞ¾VÒ¤¯vôFÒô]7)LÍÎooäod )'XÔcÂýÅw š–dO^C Y„c€O^IéÎop­ VJÊ­\i &Ìð¾™óÍÀ „«»ŒÞȱ¾ë&…é9ä7LËžP:”Ù^ÿrAi &ŸÍòFL·Ä$^Z&eô:i®{&lv~ǜ؛‰ÕoùåUŽÉÙ)ûûÉÞ¥¥+)¯‡1+¡dƒ]C¸õ‹Â„Óä·ký«x£[1"¬6 ðû®œmXoæÊ!^Œv½‘c}×= >‡üÆYò\»Ï§-Su‰·2 S¸†ÚÃ’ôfÿ'£]Eo$Mßu“ÂÔìü6˜—}¦‹ªUT^Ôc²7D R0؃4î‘,“k Ù&œáúäVgÉo ÌVž?æR©4 “ï¹.Ä”4Þô1áÉhWÑ9Öwݤ0=‡üÆyÙ“L‰Àe\kÙ“Â4@L!œ –>–âÝjöÖ2)¢7’¦ïºIajv~Û^6ºb`°ßyQÁ“ë¼€hô™B‹ –ö0(¹æ·¤”>¨ù}~=ãsásðÖ:G¼Y™ˆÉ>Ó÷í‚ÓÍVOF»ŠÞȱ¾ë&…é9ä7NËž$.+æù\¦ÊÔ_Í ñ1…»ý?^Z&eôFÒô]7)LÍÎïè—Ü@"kÕÎïä³ ü^˜¥eމ§í ã"¦éÎo±w>J9/jÓ@ó+¿9&C•w9vµs—Ñ9Öwݤ0=‡üÆiÍoû&Ô§-ÇÞcªMýÕÌE+¯ý¿½ŽÒ­ƒx y—ÑIÓwݤ05;¿}iȶ Ѷcaõ®œ¦,3RôfäEĤ>Á yJHc͔ߦYò[¨ DÙÊUÜǬMͯp¡rC”w÷11µ£7r¬ïºIazù³ä·å?Û×a+{ EaªLÄä—³.Ä᫤¡“Ñ®¢×I3pÝ£0Q³óÛöqÙ•¬–Æ%¡8¿…­»ò‰¬Éž¼¶O*ÙG(Ÿìc¢Yò;+ø?hÄr|Si ¦ôå<ÅÍï8&Š_íèë»îQ˜è9ä7M“ßà]Õ†El­ø¹ÿ¯MĤö.\ˆ‰^(­¤¹í2z#iú®›¦fç·wm£ÕÛ~ ÁµÃJ§‰¢_¤³m.–9¦È™Á¥‹Â'Ûhžüö¹H1“`y*W™Fˆ !~#&¾ÙÊÑ›Ñ.¢7r¬ïºIazùM³ä7Û¦ƒ7åŲ0U¦b¦K]ÀÖk¾ÙD_íè¤é»nR˜Úšß¾›B×j‹1¼+'“5úߪdqy®œ?ŒVÀCNDðÉa4-{®Å¢ ”ê•i€˜lÇÅoÄî8&º´LÊèë»nR˜žC~Ó,ù]îÈ'zT[¹Ò4@Lo=&{,ÜÁì“Ñ®¢7’¦ïºIajk~{†«b– pœÊÑ Ç%¡ÏHqÕ²áÁZÉ1E1¼*~¿"Ž«Úo Ó$ù‚a¢¬lI!­S™ˆÉË]ˆ‰mçu“c/F»ŽÞȱ¾ë&…é9ä7Mk~gû*¼»Ì%€Š­\i &Ò÷”TÏÚ›Kº„¼Ëè¤é»nR˜šä7úð¤ èm«VSò.[ÄY}ÔÙê©\ !‰Bˆãªö›Â4Ýù£Ï¸±½­j‰˜JÓ1ÉKKþ5r8ß ÅÑÕÎ]FoäXßu“Âôò›fÉï ƒ$±¯„&Mm & |Ýüv¥ú›S9>í*z4×= 7Éo§N”œ³Oy‘c ×®_¶ª.à²ú~Kƒ¦ðIKž%¿Ñ6`ö[YQ!,,+Ó1ÑëŠÎ˜èÕÞʱøÕŽÞȱ¾ë…‰ŸC~ó4ùÍÇ#8Þý1•¦b²%ì˜ð1ñÅh—ÑIÓwݤ05ÉoÛøHAq1©°ˆ˜Ø/¹ƒyÇßj»ªnÈ`ÿè“O“ß †z•Ø6³ ¿KÓ1ù-Û 1yÇÖMŽ]Œv½‘c}×M ÓsÈož%¿!̱W¿”Ö-MÄ„ú­` 9¦›¤¡¯vôFÒô]7)LMò;Sö;!ƒÓRarI%1 D˜½}||°Vê1IP‚`û_ Ÿìcâiò;rÈ9:è-ä›kÓ1âû®œ•à›‹â|1ÚeôFŽõ]7)LÏ!¿y–üö('¶šÂRŒoªLÄ„QÞwåàfŸŒv½‘4}×M S“üΙ¢AH/M˜9Z’à³¾#®rLö°!%vœùš§õ±Â4Ûù­~%Ù0dWSú‰˜JÓ1EÒw“aÑ;Ät¶sWÑ9Öwݤ0=‡üæiÙïà Ç ¢ù­6 “½Mo=&€|W˜.-“2z#iú®›¦¦ì‰a;6¸£¢_/YDLÙùBÒŒ¸z*çG~X‘ä³[¹iÍoõ® èóî~¦Ê4šö,áÍ1¹¬ÛMŽ]BÞeôFŽõ]7)LÏ!¿yzॄC¯Dü®ÐÏÂT™ˆ (¾ïÊA”›Îo¹¦X–Ñ뤸îQ˜¤){’“mlEŽKëV^“Ï›=î-ƒwo-"¦£Š7eO2øEa’éÎïäSsý¥7Xò³0U¦Ñ´gyß.ƒÒ7<¦\íÜeôFŽõ]÷(Lòò[fÉoq-W­õ)‰? Se ¦øRÝ?“íênšßäd´«è¤é»nR˜š²'³k"øÌ)κ´•sÛO°Ú{ÞB¿ˆ˜ìa„ƒà2ðI=&™%¿3úŠÂê„~)­[š†Óž¿“}67¨\𫽑c}×M ÓsÈo™îüv=ÿº©T°,MÄòø¡˜-W;w½‘4}×M SSö$圀P1 `ˆkˆ RVT²­«(Ž~&=,Ù[|ó'¯¤È,ùm„íÕ϶ºàÏ«M£iÏHou+»7ä·œŒv½‘c}×M ÓsÈo™%¿ÅçÖ0ûUÓBö´6 “˜x#¦îV³“Ñ®¢7’¦ïºIajÊž¤$9(GöC²´ˆ˜ÀTuÍn`¢EÍoØ'ù<ƒ"¦iÍoƒ~éüàëgaªL£iÏøÖü‚ÀéŽ.¸„¼Ëèë»nR˜žC~Ë´ìI`°uŽÉÅ{~¦Ò4BLå˜î’æÒ2)£7’¦ïºIajv~'{…l¯¡ö9€\DLŒ!¡ØßKñu›~1ÙÃDˆŒä³e>Y˜¦ÉodÛŽ‹9¹FP™ˆÉǤ\9–™ïrìb´Ëèë»nR˜žC~ËÒÀKò¹)´^þi!&}ßüöÂtÃ1éŸS,ÿŒ^'ÍÀu¤ÍÎoõSg¶½'sÊi± üh('¡do ,Nⵇƒ:É”ýþÆ'Oåt–üfW€WÛ„A„b+W™F³ õ{v¡wÝäXüjGoäXßu¤Ï!¿u’üÖÌù£’‹ÛG¹•i„˜ ¿S¸›Ä«ðÕŽÞHš¾ë&…©Ùùm{±àê^%DÓ"bò$|hä® ¼<ŽÇe™Ÿ¼’¢Óß1ºüZH~KögŽU¦Ñ´çoÍo—T¿á1õjç.£7r¬ïºIazù­Óßh¯<@²Ýu,Nå*S5‹®µq­fÁ¿ÞvÒ\íÜeôFÒô]7)Lí—¶­å "™p•còÖm {Q@SZFðz˜#+Øÿ£%¿u–üvÜÁje1í¹6æw¯\Jù1ñW;z#Çú®›¦çß:­ùmùe%…’­Å•”ÊÔ_ÍÔ¼S@½éÊÕKÈ»ŒÞHš¾ë&…©Ùù³0åÄ0¼dª¦eOŒ˜ýæ¡7J(."&gIlÙê ã^ƒß¦Yò›ìC ï¢TLâ©MÄ)¼{åRˆw…éd´«èë»nR˜žC~ë,ùMÁïcÙkL‚ÿy%¥4 ~#¦pÇ1Œv½‘4}×M S[ó;E×§‚ÌY_” ˆ)úqœHò¦š¸&­ûz8ÚºÏ~³P?º•›ïüöv.tX^I©L£Ù…Þ Jwš_únç.¢7r¬ïºIazù­³äwPM  hËk)âUšFˆ)@x#&¸­“NF»Š^'ÍÀu”šä7rÌÑ6Õ ‹§r®f•Ô“íÆ2-]Iy=lo˜ËÅ)Žô~Q˜Ò,ùl;›ý‰ýjE»@eM{¦ôÇ´g½iII'£]EoäXßu”žC~§yÍï̤ɶKYËS¹Ò4@L µÿÏéÕˆ¤y yÑIÓwݤ05ÉoCJ>”™ü¬)XFWÖ%Ÿ*@Æ3+ Äd£°í Õ>¯Oª ¤Yòo0%ˆ¥®|m!¦ï>&ÝwW˜NF»ŠÞȱ¾ë&…é9äwš&¿Å8'!AqW®2 “½HÇ”5¼æ5’æb´Ëè¤é»nR˜šßà²#ìLSÒkâÐtÒd+GN§©ßÂ}¼óIcXKö’I€<õ›Â4-{âíG¶óò+:ESeM{¦tµÑG×u»)L—–I½‘c}×M ÓsÈï4K~²‰â§?‹ëµi€˜l…¾V3ï¡Ñ›Ât2ÚUôFÒô]7)LÍÎof¶ßVÉe7_ôÇd»¸@Äd—¬&80X çCâaUûMašîü9úUlßà—ˆ©4 zårJï“_A½iIIW;w½‘c}×M ÓsÈï4O~“Oºu¦”~ž˜Ô¦bâ÷ ¿ºz‡˜ÞŒv½‘4}×M S»ó[å6¥5¦EŽÉþJÌ b›WÎq1 …Œ^˜”5§¦iÍopU€³O&¿T‘ôN qXS˜fÉo®|çÂí±Ð•¯M#Ä$¯þ¸1Åp3‰'ç¯vôFŽõ]7)LÏ!¿ó´ì‰ºÆ"f[1¸(L•i€˜ˆóÕǤI¤˜(\Z&eô*iF®[&ª¿º£ )å@ZT_ê¸ ˆÉ;+ýR\€*-4A}öo?ƒí«¾Ioþ÷¦óë™È1ï®)øìP°T¦bÂo]yʱ˜l?öÕŽÞȱ¾ë…É~ɧ¦óóžH`AIèM¯±^šˆ U.ŽÉ?Ú}LÞS,‹è¤é»nR˜ššßÀÊB~YQòÒ©Ü!ËÁà€.ûãtyO~g§|ñW¢ápòߦiò;~Öàæ©^š†ˆ)ò7Çt#ßLáb´Ëèë»nR˜C~ŸŸ÷8i ddŒÑÞy¬Sa &C5oÄ!·Oå(\Œv½‘4}×M S»ó[ È~ëc\ÌÊnÌ·rù¸½™(§š ^·PÐG¬Ø¯ÿ¦0Ív~“ãáloZ¦Ê4BLñ=Ù!ÒKD¯U˜Îvî*z#Çú®›¦Çßçç=NšdßÙûƒ~ýGaªLÄäB“çj&%Þ¦KÈ»ŒÞHš¾ë&…©ÙùmK;f2ܘVn•—xý¹œ´ËðÒµžOšèß®n; !»õ›Â4ßù-pŒCU’¢0U¦bâ ×$ÞHñ¦]€Â»»ˆÞȱ¾ë&…é1ä÷ùy“&!@”™Ì^¦Ê4@L’®>&Éï¶r£]Fo$Mßu“ÂÔìüöÆH¶rÊ"­´"½¤uí$qµ8Û¹,6XÚ. eÊçƒíç×3Î1M Äàˆm/ Ù“Ê4@LþG]ˆévD8…“Ñ®¢7r¬ïºIaz ù}~Þã¤1èê¢nÀö”}L•i„˜^“QÄ$rs*Gñjç.£×I3pÝ£0ŶìI ¾³…Øâ,Ño¹%ua­ÉŽ.-à<“и×à…)Îv~«0³%çÛŠS¹Ò4BL!¿ïÊ¡hû/ų»ŠÞȱ¾ë…)>‡ü޳ä7úÚžlëÀ¶Ò–ˆ©0 “½‚׉‰82¾)LðÕŽÞHš¾ë&…©Ùù >qZ­.C{¸T˜þú7âkqöÚtò( –¶ƒ³ë‚¬q¸üMaš%¿“ø%fPlå*Ó1iLoÄDrÃ1œѮ¢7r¬ïºIazù'Éï0Ålû¤„?Sm ¦ÓÕc"~]ï¦0½í:z#iú®›¦¶æ7§—e¶ß|ùJŠÁA wa‘c²ýcH­ŽûÌëÊžœ_Ï8ǼÏ4fï^´=f±•«LÄ„ôÍ1ò]a:í*z#Çú®›¦çßq–üŽSJÄÂR ÅU¦bb}#&xÍ•k¦“Ñ®¢7’¦ïºIajv~²$ç¿ÉÏ*—Èï¿þ„áèÙ’(¯Ñp ˆÉV«É»,u¼‰üMaš%¿3«g„|–ÀÏÂT™ˆÉ>’7b‚WOS«0Œv½‘c}×M ÓsÈï8K~3ä÷±í–Ì?“¦6 SÈñêüæ$zC~ǓѮ¢7’¦ïºIaºéü¶w(ØÔJÃ⩎L¢öJJ‹WRìá.Qç3?J~ÇéÎot÷DJ.´ð“c*MÄp^wÄoîÊQ¼Ú¹Ëèë»nR˜žC~ÇYòÛ»ñ¢w/¿·ý£0U¦b òîçc…pÃ1ÁÉhWÑ뤸îQ˜ Ùùí:!g+¤¾¡Zز'Ä~>Fqé²Å+)öpòÛÎãh”ÿ\a‚Yò[2¡%ù›1U¦bòŽ‘ 1E¾ßDp2ÚUôFŽõ]÷(Lðò¦;¿2{P«ÎïÒ4BLüVt5€ÄW;w½‘4}×M S³ó;r°<šs6˜·Øùír'>Jm'·Ž˜2¿íœ|Á¸ªý¦0Í’ß9ù©…ïô#”[¹Ò4@L1ЛcŠD7[98í*z#Çú®›¦çß0¯ù¶²ÚÛB)W™ú«™½ƒÇQ®«îû™ëÍ]9x yÑIÓwݤ05;¿£­»b€Ç^Ã1no1ùœÃfÍ!.TµãÜÁ¡RB°ŸBþà%Þóëç˜ú YÃÉ…¢ ËÊ4BLçiÛÃNF»ŠÞȱ¾ë&…é9ä7Lw~«½<Ù²¯ñ? Seê¯fÙ‡˜…É“?tS˜®vî2z#iú®›¦fçw¶Ê€ªÙþ£)\Úf“Iãô=G>·4¯¦ãáD)ÛfùÃ…i–üV±­Ù²åÛÛ¢0•¦b øÍ19wpS˜ô«½‘c}×M ÓsÈo˜îü¶:eòéŒT#(MÄä«ô…˜B¸ÝÊ]íÜeôFÒô]7)LÍÎoN.õ.A¢˜—4¿ÿú7¿ƒ†ˆB‹Bqö°UBŸ‚ǽ¿)LӚ߬.Žì ¸Õ%ÞÒ4@L!¼URcH7zL—w½‘c}×M ÓsÈo˜–=ÉB`/½÷¡h°¬LýÕ,eÁp"&Ján+‡—–I½Nšë… Ûßäå>à•ei¯}’VÕÊ.æ´¦ùíÛOö6ÛJ¦O*Xž_Ï8ÇÔñˆG"{ë‹ÂT™FÓžEÞßA^{äFŽŒv½‘c}×= >‡üÆYòÛ…ï 'C±Z¨ V¦þj–Òë tÄDJ7ÃOF»ŠÞHš¾ë&…©I~[ŽÇè'ЮpÌ*Yx™$k°JŒY8ç‚êÐè³G³íGÔªøygãS…i–üæÈ)Û,&-&ñÔ¦Áɯå½S¸k°Ä“Ñ®¢7r¬ïºIazù³äw° b/€_B*…â*Ó1I>îuˆÉ¶›Îo<í*z#iú®›¦&ù®¨¤>Ô<®Í•ó™•äã¯ìÅ»rVÌ‘˜]ûV>¹•ÃiÙüޚ…T¦Ê4œöü¾]àbxm]yÂKˤŒÞȱ¾ë&…é9ä7Î’ßà³Ggõ^ãb+WšˆÉv.ùBL$w}Lx2ÚUôFÒô]7)LMòÛû¯QÅ}Ö%òÛ7)~EÈþbÔ£7leDxðAYS ŽŸü¡áç×3Î1ƒ»leÖ¤–/+Óhv¡¾UR}Êñ´^Œv½‘c}×M ÓsÈoœ%¿]’Œä˜ËŠËÊÔ_Í4¿ÄäÂ97Is2ÚUôFÒô]7)Lmò%3m~6æ5ÄYUò(¿‰“W Óñ°Ú®2¤œ7÷c…išüÆœHl}ÌÕˆðÂ4š]å{v¡7´sìb´Ëèë»nR˜žC~ã,ùb¯ú±—æ¢] 2õW3[iâ›cŠ)ÞpLt2ÚUô:i®{&j’ßœ}y°•丌˜ø¼uNV]Ne 1%ôa›~ŒÉaøð/ Í’ß>ØöHY J=¦Ê4š]¨ïÛÇDÏ›;í*z#Çú®{&zùM³äwdIÀ¢µxY™ˆISÌb²oú1|µ£7’¦ïºIajÊžB †[P®"&ߎÙV ‚fXEL1 ½`‚.ÜŸDL4I~'84©RFçò º 4f†xõ1%Ã7á&Ç𫽑c}×M ÓsÈoš%¿QP²‚&ïT.Sa &[¦¯ã'´:r³‰¾ÚÑIÓwݤ05eO„ ëf‰¶á •EÄm[ŒÉ6tÈWS4äJlMs:Èï¦Yò[G— %2XlåJÓ1¹êû9»PO ”FŽñW;z#Çú®›¦çß4K~Û—{ü*Kq%¥2õW3oW¾j›S9:í*z#iú®›¦¦ì‰+ “3~wm1y«@Ìé…&«$wºòt y—Ñ9Öwݤ0=‡ü¦Yò›Î¤öQÁ1U¦þj&¶gá 1‰kM¶“æd´«è¤é»nR˜š²'¾÷ÌNW0ЦUŽÉSðV¿ ŒÃƒµ1×`2Ó¡­ÿÉÂ4K~SBHÙ e²ßìgaªL£iϯÓvøá¦]€òW;z#Çú®›¦çß4Ýù l«k´—^B¹ÿ/MÄ$AñBL|Nª“†¯vî2z4×= 7eOl–è¸ãm{°xW.ºž6#Û;âÂÝ«“KÄø­ úQÄÄÓšßRt™æXê1•¦b²ÏãRÐŒé†câKÈ»ŒÞȱ¾ë…‰ŸC~ó´ì‰­¯’bNwÊ>¦Ò4@Lp‘ßö^d¢›¤¹´LÊè¤é»nR˜Ú²'~ƒÖ' Øô5i 1LĈ„†4Q‰˜¼³²U1Å+LÓ²'ê”XB1ð¢6¦=\§rDÓ͵'¾´LÊèë»nR˜žC~ó,ùÍ9h ¶Â.õ˜*S5³þlø«7>ã ùÍ'£]Eo$Mßu“ÂÔ$¿]ªßÕKìíeÐ…aºï>¦`; {M‡k>& c¶µŸ?Y˜¦Éïèr%®ÅJ=¦Ê4BL‘ðBL¶¿¿™Äã]FoäXßu“Âôò›gÉo¿·Ÿ}“DË»r¥©¿š9/yé1ax³ÿgùjGo$Mßu“ÂÔ$¿I@²U&±Ï$ÐÒ•ŸÄ@Ô?Â_CîÊe¯ßhØÒ•,ÓðáߦIò;ÌŽà"'ŸýùóÚSiM{ætqú™»ÅO¿ÚÑ9Öwݤ0=‡üæIò[³$ôiZJ1•ê‚¥i€˜ÒÕùí÷Žnšß8}µ£7’¦ïºIaj’ßê§q)ºŒ% .måÂß2J J½ç`ñ®rFÒ”)ŠÄá àߦiÍoû÷±¥ù]™ˆ _ã¬Ädäy y—Ñ9Öwݤ0=‡üæYò›Õï¸)‚+ˆ©4 SïS9ðQËí¤‘“Ñ®¢×I3pÝ£0I“üŽ~ñXmwËÎ-*XD´}˜aƒÀƘ u±.%„õ“#Âe’üN!“}!ä”b¡ùU™Fˆ‰Âu’ Þq“cñ«½‘c}×= “<‡ü–éÎoqµ 9äbÿ_›ú«Åè@Làf+'W;w½‘4}×M S›üÛ„1C€`ERéÐcòÎqÛŠ±mÌ,08ñ-蓈I¦eO²r@d•ÌÅ•”Ê4BLg‹€#& wíri™”Ñ9Öwݤ0=‡ü–YòÛÉ8.Q.Nå*S5#Û€¤ 1!¤»¤9í*z#iú®›¦ÍoANäƒ<|&ÁbòmE”L’ì-I ³ŸŽ÷Õ‡“ƒÁ&^Ë?Y˜¦Éo´ï/úÅêoa!¦ð¾­ï,åb´Ëèë»nR˜žC~Ë´ì‰XLÁÛ~¦Ê4@L!ç7bŠùîJŠ\Z&eôFÒô]7)LMÙÛsØFNÙ;^úy ˆI {BN>ä„Ó*bRI‡SNhÀë“ã›d¶ó;d¿ý'9Ø®¶ècªLÄç ¿õc;Þ›v9Û¹«èë»nR˜žC~Ë´ìI4èêàÁ™ÒŸ²'¥©¿šaŠb²½ú]aº´LÊè¤é»nR˜š²'‘B°%]ƒÿ .÷[‡Y3æpÅ%òûØáHTM1ø'÷ÉÂ4K~û +ˆ¶µD,ä›kÓhÚ³¦ëˆSPøæÚ“œŒv½‘c}×M ÓsÈo™ïü6b QJ„1Y™ú«ž}%Ž˜¬’àÍj¦ïvî"z4×= “6eO"s¿ä’L°D~;è±W$ÅCU)¯ ¼<Vñ!|Êñ“ä·N¼´_è5&s9Œ 4 “O ¸2ÝßzM±,£7r¬ïºGaÒçß:I~ç çðküöÏ®ÜÚ4@LÈ€'b²î Ó‹Ñ®£7’¦ïºIajÊžÄW¯€‚mÈ^—àWa&×s Y ¬rLDš_ºäÊ' Ó,ù-.D ÷–wå*Ó1…ðžölŸÑMƒ¥žŒv½‘c}×M ÓsÈo%¿ Û‘àÂdE»@e &€÷\¹¨p§. '£]Eo$Mßu“ÂÔîüÛ¨z¡ÄK[9=Þ”ÉÎ ®Nⵇ%¢k2¡Åøä0&¿mgÊÁw™T¦Â4šöœâuWŽêM¯œ^Œv½‘c}×M ÓsÈoxÉdÛ J‚PÅצÁ̯Lñ˜Xáf_S,Ëè¤é»nR˜šß¶•‹É°•C—‡1ùðŘÁàÆ•ªöº©€è˜ ­Ÿ$¿u–üNŠöÎEoÜþY˜*Ó1d¾§»Îo=í*z#Çú®›¦çß:-{’8zo22/,+Ó`JªÆp© ¸&Æbº´LÊè¤é»nR˜šß‘üFhBÛ‡òÒ”ï×\9 ö¼„˜1wcE“_´óÑâb“>9%E§5¿³·S³­[PˆÖ¦bzåØ˜ˆñF]@óW;z#Çú®›¦çß:K~{¹¤X(Si &º,½èæº@ _íèuÒ \÷(L©Ýùí˜QXCf]<•K^ƒ½7Ó¶ƒ«så\îÄW@ q\Q˜Ò4ùíc²kjjÁcÖ¦Á´çs,Ø1í"ÞlåÒÅh—Ñ9ÖwÝ£0¥çßi¶ó›ÐŠ`¯<…òT®2 |k~Gˆù¦Á2íÜUôFÒô]7)LÍÎï¤Ñá¢ØKaQ] ‰+vú|•,¬«“xíóþ'ÛE&IŸ<•K³ä·m”r´¥¸Y™ú9–]¶âÌ1¿\pÓ`™NF»ŠÞȱ¾ë&…é9äwš%¿ÁEëI•÷Ÿ«Ym &[Ÿßˆ)Bº91I'£]Eo$Mßu“ÂÔìüf¿ëbL/¡ÅyÄ”ƒßÛBÛ’ !-´êÁw½¶}{ÛòG Ó4ùmh—ÙïC,ÉïÒ4šöLùºéý®0]Œv½‘c}×M ÓsÈï4M~§à²?â«t!­[™FSR%¥s5Ë9³©‘4£]Fo$Mßu“ÂÔìüÆèý‘.¦á긋šßÙ^¬sô ãKíþ°=$bퟒßi–ü–ðÚÑ¢Ú§Q¦Ò4˜öLåÌ1bºS°L'£]EoäXßu“Âôò;Í’ß]íð%ýóæwiM°H¬çj–C8.¶· ÓÉhWÑIÓwݤ05;¿SâY¼õ[b¼†ÇL%Ÿ=E—yõlM:¡,,ƒ‹ùúí_û¹i8Éà7…i’üNüÀ }Fp‘c¥i€˜ ãuòKÇQH»0å¯vôFŽõ]7)LÏ!¿Ó$ùí­ÉÂl‹íççuÒ4ºùŸ«™žIÓ(L9|µ£×I3pÝ£0å6ùÍL>E!‰ßM5ÄäwI]åÜ ½í0–çÊD‹(/ÚýS…)O“ß‚”€T.ÉïÒ4@LøgõBL‘nšxóÅh—Ñ9ÖwÝ£0åçßy–üF0‹.Tòc5«L£®\ÈÇ$In ÓÉhWÑIÓwݤ05ÉoŠöûF+NJA`y®œ½"âÃt#gÖ–Ró;çˆh»ÀÌ/˦YòÛ*l`6Ô\‡åGaªLÄd•þÍ1¡m¿n ÓÉhWÑ9Öwݤ0=‡üγä·H ìöéçÍïÚ4XÍm3ì綾’›ÂD_íè¤é»nR˜šä·€-èª}Z;¬"&`0ˆ˜l'(AV“í{ ¬©ßqÅ0œýô›Â4K~«O]2ÿì$NQ˜JÓhÚóKêäœöoZRòÉhWÑ9Öwݤ0=‡üÎÓ/³½>|Û^Ÿr®\iLIqÁÅ£0ùô"xž4’æšbYFo$Mßu“ÂÔ$¿Uˆ™“¾ÆÇEÍïˆà•«,1,¦ãá|Egª>Y˜fÉoN”li!ÍX°Ô¦Á´gB¼tå}|Ó’’OF»ŠÞȱ¾ë&…é9äwž%¿53Qðû)í•i Ç„pðJŽ˜C¾!¿óÉhWÑIÓwݤ0µÉoÛJIyqu/ú^㛲èê$^d¶ ýî3ép(Ýo Ólç7&Ÿq«ÁªíÏÂT™FÓžåÍc¢²ÞœÊå³»ŠÞȱ¾ë&…é9äwžÖüfI˜Å äB©2ú˜§1Åø"mëÂÄáò.£WI3rÝ¢0qýÕ9bÊ]…R­6èYj°tÐ#˜¢k–é9Ýx 1 ‰_ãµoÈiôðIs~Þã¤Q• èÀœ‹Æ¤Ê4€ÙŒøFÈp£ÇÌáKYFo$Mßõ×Jóÿþ·:*þÿí¿þÿËú§þûñ÷ßUþ×3¯‡þ»û×ÿÏßßà/ÿúŸþò¿üÓ¿ý—ÿjKÌþ/ÿñ¿üý?ÏÿÏÿúÏÿñßþé;2÷/ÿøOÿv:_kQþõþÁ¼þOÿýßÿOÿí×_~üóÿøŸþü?ý·ö'ÿí/ÿ³ýb³OÀýÿáü§ÿÿCüúËü—tçëÿÿß¼^Š×ÿþå/Gg"Q‚×Và/ù«2!ñƒ£Ä•ÿüõÈÉdzöoÞá´“·í½æíÆ×Ï[Û…:Þñ¯ß‘Øàðùü_}Ž¡½Êù€ÓuÄ#N”tÅ>/ªyD:í`HÁo°|ÿÕ=œû©fÄ?~Çó-„?>ÇÁê”®ßÈ~ «}×çPEŒñ‘Þ¯Ï1©ß°=‡¾~®g;¯—öRûwÌrýÕ!¾#âû›Éè*Lß}²RH·¿£ýÕñÞéŒB„Ó÷7“ ¡$—xºýf4êùo–'GD¼>Ç#ûÙžÜKÝù͸œ»D滈bÅ%žcþŽ—ýÐ…üã›±jn{g½ý«IôŠ"¾#^ùè×x¢m¤¿#FÌY5Óí_mí¸"žCñÏ1zW™PüãwôÒöíÜŽ!ç÷ûøKôÇçh»ûDx2¯ßѯ>YØÿ¥Îð¿Æ¿‹ÀzûÙ¶U}G¼òÑ_j¿m~~3ÞïƒþÖ]ÿ—òwWG{ýŽ>#ôñúÙ¾ZÑïì‰)yãÜE ~âsþÕr~3ôÇçIü¶ÕŸïŒ½2–¯ÞÉöçÞߌ½×gÿïm õÊÿßýÛßÿúç~áïÿø—>‘Ç?üëßÿÓú§øû¿ü+éÿö¯ÿÓ_þöþ×ÿú_þÏÿð?Ò_ÿ‡ý—ü›¯—ÿáX ÿÃÿö·Æ»jÿü7ïóÅþXƒm%þ¯ÿðÿÏÿé¿þó?ÿ¯Ç2^¯ÿô/ÿø÷ÿŸ+ÿM½™ù^˜^¿Þ?ùïwý=ÿù_ÿÅ~y[Áþíïÿßÿú÷ù‡ÿõ/ÿÓ¿þãßÿò÷ùÿÃ?ÿýÏ`¯í¿¿âüÛß_KèõÃÿ“­¬ÿúoÿ—󣋖xž üÇGùç6Ë–ø/ \< ϳüw9××3Ì1—7Ëìí^J1èŸ9Ö0 fÏó!udÃ;~Ñ9ÖwÝÈñ/öÿÐEðGÒLžÉ«}%¶ ’ œ_Sš s¾HÛAx®•4ôÕŽÞHš¾ë&…©y&O˜ý®Šmý4¼6- D"¹(Xòy·š`-i…#çxHèG Óì™<ùA¨m0Q©”‰¬LƒÛØ>æü<¼ù ÝäØyÐ^EoäXßu“Âô”3ùëó'MJ.D¡à¤d(š…*Ó1 ¯“–¿ZaŠñ®0íUôFÒô]7)LÍ3ùL¶ï«Õ9ÒR£ïYmáÆÄNSðI M#¦L¯»U¶Ý”aIüMaš=“Wûk€½Ó§ER™§/Tt ?nåØyÐ^EoäXßu“Âô”3ùëó'ÏKY ‘DŒåð¶Ò4Яå W7/hÌw«Ù%±VFo$Mßu“ÂÔEbK{Ÿâãç9CM´ŸˆÉª³ªˆ£®µ¤ñ‘LÒb’luís£H®¯gœcšÐûÄ5Ô}µi€˜"f}#¦|©VŽíUôFŽõ]7)LO9“¿>ïqÒ$´ï‚|P˜æTÝû(LƒÕ,åoÄäêVí¤‰á«½Nšë…)6Ïä#Ø^Ö–àŒ³,M•ô KöÅ;ýbÚb²ŸÌàƒËcÎ9 ç˜ü¢0ÅÙ#üD9ÛGa»%,ÕØ*Ó ÇB’p!&Ÿ‰p“cç¹|½‘c}×= Sü?6Ñþ#i¦ÕØ‚€Í~Ê\N•¬L#56ÁðFLYï Ó%±VFo$Mßu“ÂÔE"à4-§ÙöU¼Æ1U¦ û8í¥Âd?9f+…lº~p+g/¤³¢le!Hå¸ÛÊ4ȱùz"ºË±ó–Y½‘c}×M ÓsÈï8=‡›Q­¢ä£·´(L¥i¤-B.Ä”ø&i®áÚeôFÒô]7)LMòÛö²¶ë °Ò`efñT )ù\è@Ѷe¼–4àd‰Õ3¶Œò°$þ¦0Í’ßÉvùè÷ò,- ò»2 rÌÐ']ˆÉÒâ†ÇŒüÕŽÞȱ¾ë&…é9äwœ¾¦â’Ž˜¸DL¥i¤Æïk^Ý󭤹n™•ÑIÓwݤ0ÝÌá[B†@œpqx›½~™ü*¨¼¶++[9×ÔôƒhŸ— %½S˜¦G‘ñ¹{DÞë\¦Ò4È1ßß¾SN7/ ó 1ßóEŠè¤é»nR˜šä7P`û­ ñ°3FkÓë/¦`µ˜W…m×KL”Ãçôk¯¯gœc>€@3’*Ó1%ŒoÄÄw[¹üÕŽÞȱ¾ë&…é9äwœ&¿³HFñ†þ‹ i•i³#]c3¼µðæ(.F»Œ^'ÍÀuÂMòÙçŬ¾©ÅÑþ1©6¬Î©ÉÒ©œÿdˆ€ÇU8?ÿ`a‚i56Žà„P¿3ôS­4 “=ðîcâ”o¶rpI¬•Ñ9ÖwÝ£0ÁsÈo˜Vc<¤ámçQö1U¦èQà1¡½P7'&pI¬•ÑIÓwݤ05Éoâ V•HmOKiqx[TD—A ãJÙZƒ%»l®W2;>üMašVc³ïÅP´-,EaªL#3Kº“¼T@Z9vI¬•Ñ9Öwݤ0=‡ü†iò[Õoµy+`,Ú*Ó i(¾¯›£—ß$ÍÅh—ÑIÓwݤ05çpó1‹$`’eމÑoÎä!ÀµÎïã''¯ãVÈcÊŸ›Ã}}=ãó««àÍžöÖç²] 4 “@Œb=²¡•c£]FoäXßu“Âôò¦ÉoäC¸Úöª0•¦ÑQnŒWF½;Ê…‹Ñ.£7’¦ïºIajÎáF…­] |i+wè(Øâ ÊVOåÄ'ÆQtÅoIýdašîüFïŽÕHE¯\m,~,pÝ•³—ïPùÕÎ]FoäXßu“ÂôòfÉoÛ2D¿ÂèzB…Lde4¿ÉKí@L€ù®0Œv½‘4}×M Ss·F?LTWÈ k_¢G)ú±ŠÈX¼’b?™²ú\ ²Oë£[¹é9Ü)€ý:ýÎcÁ1•¦bâÞ“êÝ}L¸†k—Ñ9Öwݤ0=‡ü†YòÛõ… $³r*Nå*ÓàJÊ¡Hq"&Èr³ñd´«èuÒ \÷(LØ ¿}fFˆ!¥€†[p\J™ÈhX Ñ>O+Æ‹ˆÉ~2‰eŠðšÎô©Â„³ä7“D_ª|'^´ T¦]@üæ˜æ›^9<í*z#Çú®{&|ù³ä7°FVb ±è1©Mý¤ÁDïy>ˆ·7¿ñd´«è¤é»nR˜š²'®ñh¨…#d,\DL`¨'Ùßýh.®$ÿd+†HD’ã'·r8Ýù4µ-yÁ1•¦Ñ.%¹S:E 9vµs—Ñ9Öwݤ0=‡üÆiòÛg®»Üšß,8¦Ò4=¡pN@tá½ë1Á‹Ñ.£7’¦ïºIajv~»®¤­ïŒÂ°Ê1ù9?+ºb?çEÙ“,¼é+§”3}ò®N“ßöG¸.[R”äwi &×¹ºSºÙÊáÅh—Ñ9Öwݤ0=‡üÆYò] ‘PCˆÇTšúIÃ.‹v!&º%&ñd´«è¤é»nR˜ÚßöYXaJŒìǼ6ökx$¿–B.<½†˜ì'Ç]{4çßü›Â4M~µRD±œ\Z™ˆÉÒêúW˜hZö0©zÇ)‡¢] 2 “ß{9#©4 k©y^ˆ‰__o+iNF»ŠÞHš¾ë&…©Ùùí£´£ážp ôý™4VT"ÙKbG /ìñüÉ>ÿ;ùµ ü$b¢ù9ÜÞièS‰˜*Ó1ù”Š 1E ›‹âô®]DoäXßu“Âôò›fÉoD{À·…ìIeÅû|µ 1´¹+LôÕŽÞHš¾ë&…©Ùùíº¯ˆ.ÖŠ®?²†˜²SL.ci¥ØþúÅámö“5ú4,I>É1Ñ4ùYlO‹r9î¶2,^SvÄÓÝ ]Œv½‘c}×M ÓsÈošîüö±~äm7©’Ö-MƒáíùÎo 7ä7]íÜeôFÒô]7)LÍÎo—i±ºpe0¤'MJÙ¬9øUܨ«ˆÉ~r¶ªæ­L†[?Y˜¦Éï(™ý.@¶­m˜JSñ³¢qÊ<äôîÈoºí2z#Çú®›¦çß4K~ÛN Ň;æâoeê'Mbæku·×‘î ÓÉhWÑIÓwݤ05;¿£¡¥l¿°_ q8 û'b²­B bŒ¸°|é1ù?ª0Ã5RôC…iºó[bRoaÐêoe\O® wBqtµs—Ñ9Öwݤ0=‡ü¦iòÛöÖbyì%ù]šúI“}øö…˜”óÍVŽ/F»Œ^'ÍÀuÂÄÍÎ¾· sàÅS¹]Ï:æã8’ªÚk{o…OZ‰! ò/ OËžP✎Y¹åØîÊ4XüìC bÂÛkO|i™”Ñ9ÖwÝ£0ñsÈožîü†lߊú¬¿PpL•i³Í÷âZ1!ÞœÊñÕÎ]Fo$Mßu“ÂÔìü¶-\Ò,€>Ö9ÏÆ~"&U1|蜕$-ì_ˆÉöÔ™!J¤ÈŸDLí*z#Çú®›¦çß•äwi]°”|!& w…éb´Ëè¤é»nR˜ÚßVÐÖ`u²g|6V ¦˜SÌù=YDL\š @öK1Ÿ,LÓ²'3C°=f* SeLâ!¾“`º+L—–I½‘c}×M ÓsÈo™x²DÕÖP^â-M#I ó}#¦|§Ç,ï)–EôFÒô]7)LíÎo `Ë{Â"­ìÆ1ñ¡æbÕóŠ4ž?Ù‡]G¿•ªŸÜÊÉ,ù­œ2³_+M¼µi FèÝðb’ÛÎoá¯vôFŽõ]7)LÏ!¿eZöÄ€ºî…©2D¼æ 1¹BéMÒ\Z&eôFÒô]7)LíÎïcýeq•Å—.ñºN%ŸŽšÿ§r, †µ åøÑ­Ütç·wÁûµbÄPÅU¦á¡ú~"&E¾™’"W;w½‘c}×M ÓsÈo™%¿ƒFÌȉ«—•i${ŠïS9Û‡ÜÍ•““Ñ®¢7’¦ïºIajw~SŒö kòCañTŽ9DÛù`Jã[%Çä\(Ó'Oåd–üNþ E•kËŸ¦ÁÀ ÑüîüvÕ‰›Ë_íèë»nR˜žC~Ë,ùM.ÂfàŸ9J¹•+MÄä”í1±Þ\ГѮ¢×I3pÝ£0éMçw&fŸ à·—®¤bò9pí2è»Ðy"&—ˆ;n¿&~ª0é,ùí¢Áö]¶\æroi ¼zîNíß“²Ã­‹_íèë»îQ˜ô9ä·N“ß\Ëߢ¢+·6FëÀ{Üé1éÅh—ÑIÓwݤ0Ýt~'C. lk°~*ÇÁÎѶÆ@–;¿ýƒJrŠÃ’ø›Â4-{‚ ^+-A¤”=)M£ÅO¿Oå2êM»€^Z&eôFŽõ]7)LÏ!¿ušü¶…ÏßC8¨@L¥i4ZG9\ˆ ^Ó,ZIs1ÚeôFÒô]7)L7ßlin¿.ûø!Óó3i(ùÇGj¨)CXÐLy!& ¶§äïnÄÛ‡S˜fÉoñ_Ç5ï$tAmÜ•SV9§=û¤ã»ÂÄ_íèë»nR˜žC~ë,ù-bë2Æd¯~±ÿ¯M£ñÍDר!û–ïzLôd´«è¤é»nR˜ÚßrfRŒ>oQ]€8!±ßY=•Ã0)¤”íû$ù­³ä·}q!ù5Y$å•”Ò4☯‘3àorìd´«èë»nR˜žC~ë´ì‰½õEíM¢0U¦bÒ¨×]9¢¨7Ĥ^Z&eôFÒô]7)LíÎo4ÐÉ6rtõTŽP£¸ö”Ï:¸…çOVv……«MúC…i–üf{í(Ä,å0‚Ê4h p"& (w¨üd´«èë»nR˜žC~ëtç·JûŽ ˜k©ÇTšˆI_2nb¢D7«YºÚ¹ËèuÒ \÷(L©Ýù š5“¸ÀnX€W³Et‰W`(°T˜ü'§p1Â1žîƒ…)Íw~‹¢í’Ôp\˜*Ó@ÁÂÅßOÄ„~X{“cïvî"z#Çú®{¦ôò;ͼt)´o ¼’RšˆÉö[ï>&†»K¼é=ŲˆÞHš¾ë&…©Ýù B!Äl5‚².ÉžØ+—Sö1áö¬°¬rLàó윥²ÇÇ­¿)L³äw6peï;'ßbþ,L•iÈcÆ«ó#Üi~¥“Ñ®¢7r¬ïºIazùfÉoðn°}uNZÌ•«LÄd¨æ}WŽÃù諽‘4}×M Óæ7§ÌÄ™8YyZCLh«7»` H„ñ “1±O§ôÚ ~²0͒ߜż“py*W™í.»wi~Aä»Åïd´«èë»nR˜žC~§iÍoß][ÚVè¢] 2 V³ ï)©Äz7¾9]BÞeôFÒô]7)L7šßöÏ«ñò´ˆ˜„3ªýÁ¶uMË}L>æ*'1Ð&þMaš%¿3üb˜$QÑ`Y™ä·Ê[ î,ÓÉhWÑ9Öwݤ0=‡üNÓ²'ö=ˆHJœù'1Y›ˆÉkÇ1¥xÓ`™.-“2z#iú®›¦vç7ÄHéàRû,"&WêDV¿º%a1Åh8-£!®?Ù.&ÉïD#Fж·MÅKe\IqèBLn¿üÕŽÞȱ¾ë&…é9äwš&¿í›°÷À¾eª8¦Ò4BL)}#&Ê7êùb´ËèuÒ \÷(L¹Ýù ­N ï^ÔcBrÀ|4yçÖ2bŠ~ ŸÄ× SžxéS1ÕP#¨Lý#û8¿§=ãÝìÂ|M±,£7r¬ïºGaÊÏ!¿ó,ù…mD–ʱR°,M£ëöS߈)ÞÊå“Ñ®¢7’¦ïºIajw~Í.Ô*V[5¿‘X–œÅÞ”å¹rA)"ø¡O"¦<Ýùí7’ì_r(ÈïÊ4=‘ ïÙ…ü:?kåØÕÎ]FoäXßu“Âôò;Ow~GV•Q™jŽé§i°ÿÞh|õ1åxsó;ÓW;z#iú®›¦vç·o§\Ü'p²-Õ"b2¸ã‡ýÀIÃJÔ9‰—ƒßKì–Ÿ,LÓšßV%ÁÞw[(æÊU¦P ^wåùî€%_BÞeôFŽõ]7)LÏ!¿ótçwb1”|n[±•«L#ÄtÉž8b²2u“4W;w½‘4}×M S»ó;Ú6N|€R ¦§@LÁuÞBÉöÆ,¦×ONö$Äàgߟ,L“äw `õ]Rqò[™ÒºŽ"߈ Ó]aÒ¯vôFŽõ]7)LÏ!¿ó,ùÍÁ‡2Úÿ#ÈbªLÄ_rº/ŽéUBZIs2ÚUôFÒô]7)LíÎïH†ò‚mA3ÁÊ”ï×e µ} _hq—¥K¼ÇOða›âö“WRòôÀËs„裔¡’Ö-LƒaòûTŽó]S¾¦X–Ñ9Öwݤ0=‡üÎÓ²'VN$‰ýKJÅ©\e &¯LbŽmŽÉ0ÄW;z•4#×- S¬¿ºb‚à§rš)Áê”pÁqúšý¶û*bÛÈû-=oÿà•”óëç˜ð³…˜mZ´ T¦Áø¦ÞóPâ‚e W;w½‘c}×- S !¿ÏÏ{œ4É'E[,(†âº@m &ÐôÖcÒÈíS¹.F»ŒÞHš¾ë&…©Ýùí¿j²Í†¡È„‹wå\›‘0ÛKHa™c 9¢·HC–ñ$ƒß¦YòÛoí|´õ…‹&ÞÚ4xIñ»Éøorìd´«èë»nR˜C~ŸŸ÷8i ºæh;Žlý)âU›ˆ é›cÒ—ÜV+iNF»ŠÞHš¾ë&…©ÝùT(ø…løe±óÛïîÚ_êÃa_DLö“}à•_~],ûXaš&¿ ‰$ˆÐ×¹íŸäwiê瘦ôî½@‘i]K–¯vôFŽõ]7)L!¿ÏÏ{œ4ÉmleFˆ‚å\¹Ò4@Lö6à1)ÞÁìKÈ»ŒÞHš¾ë&…©Ýùį^ '!ŒK…ÉùƒZ ”V†Òáë'g?Å4¬Æ!~ü>¿žqŽ)[¡•œ ÷*í•©ŸcV¬OµCLŠ7 –V›¿ÚÑ9Öwݤ0=†ü>?ïqÒ¤èMmuFR)8¦Ê4@L¾ï¸S"j“¶ÅùjGo$Mßu“ÂÔîüö[dž—$ƒÄ´ØÇtL¤ÃÌÉ bÔ¥K¼¯Ÿ¬Ç°Í$ñ““xϯgœc>\O}p92'¿µi .àZèbÒÄw‹ß5ŲŒÞȱ¾ë&…é1ä÷ùy“&!Ck²øH­1•¦bâ@áBL¶íºYÍâÉhWÑ뤸îQ˜b»óÛj DTæòv‹šß`«/ßÄ;¸W“=€~úMc¸õ‹ÂgÉoV«¯lû$ÀòT®2õs,ûßôFLB7ê dø(bšx]8P Ã…©2 ,üªÏ™cè÷unrìšbYFoäXßu“Âôò;NËžX=a *çM·?9¦Ò4ÒʼîÊùtìb2^Z&eôFÒô]7)LÍÎï,B9ˆrbÓXCL>-”€Ä ´¢Ë‹¯Ÿl‹B '¸rbµß¦YòÛG“°7¢I1W®2 ST¹tå1Çi]«^_íèë»nR˜žC~ÇéÎïÀÞçÏ>º˜Ä[™ˆIñÐþóßÑ,o’®vî2z4×= 4;¿­< UT{w¬\gXCL1Ùs†¸\ꢺ€+Wù¡wô–>‰˜`–üvÊÌ=i¦r+WšˆÉö¶×íÌ鮉âW;z#Çú®{&xù Óä7°½;ý!`©.Pš†ê‚á›c¢›{Lö¾|µ£7’¦ïºIajv~g«¤–ã)8s?¦  Ä”¬¨1б\‘&x!&˜…ìÓ‚4ÜDþ¦0-h~ƒý-ÊÈ9…©4 zëʾ»’ßBÞ?£7r¬ïºIazù ÓäwÔàÃGA^"’ߥi„˜2Ê7b’»Õìb´Ëè¤é»nR˜šßY%G/MyHAˆÉÙ¡lU˜|+·z*'ê¢òKéc…i–üÖÅ¥þ8ú}æŸSi &Ôü¾]oxL8í*z#Çú®›¦çß0I~[1a>N´ý»)V³Ò4@L)†K]€b{JjùjGo$Mßu“ÂÔìüÎ>m#%ÛÐ&Z*L/*6óá\%`±)À”@âºg!~1M“ߨá8Œ?dï~¦Ò4.éÝ+ÛòÍ.F»ŒÞȱ¾ë&…é9ä7L¼L¶Ùˆm®^–¦bJéûTŽîÔàšbYFo$Mßu“ÂÔìüö³1Ά|XXǸ¥DL>q&ÚžÌuæV9&{ÇD]1Å0À' Ó,ù|l‹ý6Þ1Z4XV¦b:u¾^Óž1ÜmåNF»ŠÞȱ¾ë&…é9ä7L’ßšT‚ ýû‰D5¾¹08¦ÌïI¼9Ä›¤ÁðÕŽ^'ÍÀu„7ß.4l»O¼ª.`€Ar• Û™­v~û·.ž'zÎQ˜pZöįy¬où™c•i€˜·®|À›Å/-“2z#Çú®{&|ù“ä·Ì Äì¿s±•«L#Ĥð^Í ßtå"|µ£7’¦ïºIajk~ÛoŸQÉÉ"’¥Ât &ÐàPá8#Z¼+ cfðFÍO¦iÙFÛφ’÷/ü¼+WšFÓžƒ\<& ÞqLxi™”Ñ9Öwݤ0=‡üÆYò;ØŽ#qrÝûTœÊU¦ñÌ/¹V3E¹ÙÿãÉhWÑIÓwݤ0µ5¿í÷G6Ðc›*‹ˆÉG>eõ8òª“Ù!†”$¤*Xž_Ï8ÇÔ0_ÄŽRеi€˜”¾sL0ܰà[ˤˆÞȱ¾ë&…é9ä7Îv~ƒØN)øMv …P\eö1[¹c5»“¤À³»ŠÞHš¾ë&…©­ùíóÉÄÛ,%ø\ó5Ä$†\±Ó×Rƒåñ“íúÎWS€aUûMaš–=јmçÅ/Œóãoa!¦œ¿sì¶ /-“2z#Çú®›¦çß8-{’ü:Æ×Wþ§ìIi!&ýžÄë#ho’æÒ2)£7’¦ïºIajw~ûq\ÀSVOåØ*qL®Ü™˜—ÈoÿÉŽ¯ÿ)|üÆiÍï̬@jK¡+_›ˆ)á7é ¡79v y—Ñ9Öwݤ0=‡üÆÙÎo_%'Ëb)NLjÓøTîú]ÿf+Gg;w½Nšë…‰Úß¾ó´Å×_¤—èâÊ©¹b§_·cW>Y<•ãŒh˜+! }Ÿ+L4=ðÒ5‚#¢zoU±•+MÄ”P¿Sˆ7-)tM±,£7r¬ïºGa¢çß4ßùmX$±+jÓÏ®ÜÚ4êcbx÷˜øæë&iÞíÜEôFÒô]7)LíÎoÒ|Œ­´ú’ÃÒ%^ïÖ!(ù ‹ˆ‰ø4ÙhÐG ÓôÀKû¼Ž e-Ú*Ó1)~sLáf¨j¤kŠe½‘c}×M ÓsÈošx©`û5d^\â­LÄdá­Ç¤Ao¶rtM±,£7’¦ïºIajw~ct­oE_‡©Ö+ˆ s8¦ñrŠ´6¾éøÉ>U†¢Ë¤²0Mw~–vµûÕ¸,L¥i„˜2¿Q9Ë®<]íÜeôFŽõ]7)LÏ!¿i–üŽÙ{“³m8‚”Si ¦Lô­ùw=&t2ÚUôFÒô]7)LíÎoäãPÍð’Õ¥¼ˆ˜P 3±¡Äh¥m©]àøÉ¤®)Ù/Û}²0- ¼4ð¦Ï3µŸ/šˆÉïÚ¾Ü)XÒ÷ËŸÑ9Öwݤ0=‡ü¦Yò;{“°­.gV$Me ¦à}Ià®+—NF»ŠÞHš¾ë&…©ÝùÕ¥JPÍˈÉÏô"D=Ä(“¹)¡m­<}²ó›fÉoC#äœK#Š'sALV¦bòòñFLñî‚¥œŒv½‘4}×M S³ó; ¦l{ª£Ïr,pû3i2ú=>f¬¤•‡Ä$.å—¨z+þ Ó¬ì ’-)˜…‹«MÄd{ãï>¦Äw…éÔ2©¢7r¬ïºIazù-³äw Ÿk°ßVø¢Á²2 B~ïÿyhí¤9í*z#iú®›¦fçwâèr'¶ó-ÕR»€=œ}4œe‰ã[%bb?Æ †Àþû“—xe–ü¶ïŽÅŠ,hÑ`Y™ˆ 1}« Üô1ÉÉhWÑ9Öwݤ0=‡ü–Yò[)fô+ŒÅËÚ4@LHï¹rd[õ›¤Ñ“Ñ®¢×I3pÝ£0i³óûÐh!ïFâ¤<<û™4‰CÆì7yc\sÂ×OV—ÖçÀ9~tJŠNw~‹e°Mäwe!¦ð­`ÉAošxõjç.£7r¬ïºGaÒçß:K~Ç,¤\½¾ä˜*Ó1ë»ó;SºÑüVøjGo$Mßu“ÂÔìüvé‘à›*¶â– “=lP€lKæ“+óxfe˜@Áïþ‚aV÷œÿ¦0Í’ß)û=™ >òåçÉom!¦?ïÊÑ쉞Œv½‘c}×M ÓsÈo%¿ÃúNI\m±@L¥i€˜ãû®\Rº+L'£]Eo$Mßu“ÂÔìüN1øi¶Oa²±¨`é-™ ‚DÖ…&(|ýä¤ÊÞ‹ª(ŸÜÊé´æ7zšú)FQ˜JÓ1É÷}LÊr‡Ê/!ï2z#Çú®›¦çß:K~[úBæÈ´Ôü®LÄÄï>&{'ï`öÉhWÑIÓwݤ0µ;¿AÔgšg1˜—Oå’K)¢MÇ4Q‰˜$k ÃMšP>Ù. ³ä·}.(âÃ;«á¥i€˜ˆÿPIpsÀ¢'£]EoäXßu“Âôò[gÉo² ’wâCÕüV›Fˆ‰éÝcr¼í¤9í*z#iú®›¦vç7ú9o°"³Ì1¡wĶ‚g^å˜lðË¿>d…Ç3€S˜¦^ÚÖÔ»M3V#Â*Ó1qøCó›â*Ï_íèë»nR˜žC~ë´æ7C ¶[ ~"ÿ³0U¦Ç”ãûÄÄö"7I“.!ï2z4×= Sjw~ûh7W‘ BKWRô Ëuƒ —ºÀ bòÑMÙ~<$§¨>X˜Ò,ù­‚Äœm«ô³0U¦bâHïû˜îN~ÓÉhWÑ9ÖwÝ£0¥çßiºó[‚ŠªÏ±.‡T¦bb« ×j–9Üt妫»ŒÞHš¾ë&…©ÝùÍVY²ëž€á–…ÿÇdµL¬{ÏßX·@LìS}/æ<¾¥÷›Â4­ù!ƒ“^ÞÒJšKˤŒÞHš¾ë&…©ÝùM²ßîSö¦õ5Äd%Øg¦¹®’˜ÕS9"Ûñ&>îc<Ÿå7…iZóÛ¾@vñI}eÈŸ[¹Ò4BLúÇ©œÜMâI—w½‘c}×M ÓsÈï4K~#£_{ð¡%bªL#Ä”â{JJ¾½.OF»Š^'ÍÀu”ÛßDr¶DO!¯ÜÃ=e?˜¿±´•;~2ÀdÛê|ôož–=IÇUa—A/SiM{ŽÎ.¼kÈ—–I½‘c}×= S~ù§ÉoFWYÌ~À\’ߥi€˜TøÚÿs¼YÍòÅh—ÑIÓwݤ0µ;¿]ß' eF k[9CLèo}Î1rÐå>&ò5?yãx‚q¯Áo Ó,ù½õÖ/bÛv¼à˜*ÓhÚ3§ou¬7§rùd´«èë»nR˜žC~çiòÛÅbû:Š“Ú4BL9¾ï1¥Œ7§rùb´Ëè¤é»nR˜Úßâò³_=‹šßÅPÆrd]å˜$Z=I¬Qù£ˆi–üö´Ø7⥂eeM{†?4¿n·rùd´«èë»nR˜žC~çiÙ“ ~=‰¢”[¹Ò4@L‰ð:•ãp;%%_Z&eôFÒô]7)LíÎoÌ"‚3Øy¥É“ŸZ‡!bô-ÙjSö­ ËÀðÑ))y–üV±=­kz¦”KŽ©4“¦·æ—AÒ»Åïd´«èë»nR˜žC~çiòÛ/›rF´Å¢$¿KÓ1%y÷˜pà;uÁ|1ÚeôFÒô]7)LíÎo—ÕEF[â]µu 1YÛQØžŒRXk8~2…£íå2äO¶ äiÙ“äUjE:æbDxe!&ä?9¦›“ß|i™”Ñ9Öwݤ0=‡üÎÓšßÞì}™­³? Se &ó¼öÿlµ „KÈ»Œ^%ÍÈu‹ÂõW÷êcÂäuÅÅ»I—, 1Ä‚9fãaºef+I"ö†áx>Ë¿¿0_ÏDŽû$‚í•D_¾ÿä1KÓ1¥߈é¥5ÙʱøÕŽÞȱ¾ë… ÂcÈïóóžH1h ô…©2“k½Oå´½šA€¯vôFÒô]7)L7ßV[‚æ „1,ª ˆ£‘¨.ö–¦eâù“;-Aàƒ –ç×3Î1Û&¹¤VÛ$…Ÿ¨¼6 Ó1øå☢¶›x!\íÜeôFŽõ]7)L!¿ÏÏ{œ4Çh$MQ\鿘’R™Fˆ)†«‰}|ÐMÒœŒv½‘4}×M ÓMç7å,ÇfŽh­0ÙF8Qdo”ôù0ËßVÃÕ6$áСý`aš$¿“Ÿ¥‘O-e=~Ð…i€˜l‡û¾©|Ã1Aà¯vôFŽõ]7)L!¿ÏÏ{"iü,ÞöI~¡$¿+Ó1ýqóۉꛤ9í*z#iú®›¦›ÎoŸàÊö>Øc±‰%ÀQ˜\Zi1AÎNN7*ü¦0M“ßÑþQµß °ºÄ[˜FÓž!|w~§Í/£]FoäXßu“Âôòûü¼ÇI“Èïsad`V´ T¦bB¸,Ù{Ê1Ík~cJÈ9Œ+®¤T¦‘®|Œ×©œíuù®0½…¼‹èë»nR˜žC~ÇYò;sö70Æ¢] 68¦×ZsÎüºk°„“Ñ®¢×I3pÝ£0A»ó;d[ìoÈÇÑÜ"b2ˆ~¯$š¦[pL!ûAö™íŸ<•ƒiÍoE«#"PÝ•+M#•ÔøžöÌÀ7“x.!ï2z#Çú®{&xù “ä·íª]¹‡0—7¿+ÓH]äÝ•k+ýÍjðÕŽÞHš¾ë&…©Ýù$d?°=mÐEu BÊ™)~1IpI&{Õl'7ìÎüMaš%¿Y"%¿Q”ËS¹Ò4̱·æ—muo,NF»ŠÞȱ¾ë&…é9ä7Ì’ß9‹«Š¹îäwe­fœß§ro„âNF»ŠÞHš¾ë&…©Ùù­lûOʶ—bl¾†˜P¨=åAH‹ˆÉ²- l%-Èø<ð7…i–ü&Ž#fûþÊñM•i4‰Gø­`ÃÍÀK€“Ñ®¢7r¬ïºIazù Ó/]úÇ Ÿ‘øs5«M#މò»‰c¼¹’×Ë2z#iú®›¦fç·ze΀Y¢„Ùnw³5ÛV'Ç’J?“F1øtWÂG·r³ß‚–”¢¢ä‚.¨L#ŽIå:ùe?³¼É±³»ŠÞȱ¾ë&…é9ä7LËždµüM¸(L•iÄ1½n²ˆ‰è6i.-“2z#iú®›¦fç·ú%åìU"ÆEuÈ. D.Œ¼ª.`?Ö…3}ÿK€-LÓ²'bÛJqJª­\a!&}ç¾» —–I½‘c}×M ÓsÈo˜xi/€Ëfxiþ©.Pš†ˆ)}sL|×`‰×Ë2z4×= 6;¿ÅÙ¡@ä¢m‹ß LA¬¦Y©¸Øù-®{‡hŠÏâý`aÂYò;{û‚—Ÿ X°”¦AŽý¾™ï,1~µ£7r¬ïºGaÂçß8Ûù œRPûOŽb*M#Ä”¾§¤ä»¤9Û¹«è¤é»nR˜šßâÂAä\-PZÕüRÛ²}„˜ì_Ö“ýd+H’°7²0M“ß )gð¾P°T¦!Ǥß}LrGàÅh—Ñ9Öwݤ0=‡üÆiÍo¦˜2z«6äweÝ•‹òÖcöÝúMÒ\BÞeôFÒô]7)LÍÎoÑHâcÂ5ûŽn1ùé£2gû¯%1'|ýd´}¯mL 2åOö1á´ìITH®‹S^â­L#މâûvAJé•_Z&eôFŽõ]7)LÏ!¿qšü&އ֢&)ÉïÒ4ä˜â{‚"Üô˜àÅh—ÑIÓwݤ05;¿%er…ûÌÉ™‹EÄhuXó`‚EŽÉ~2†HÈ)Zéøä•œíüö {{]„¼¸]P™F³ ã{®œ³A7M¼x¶sWÑ9Öwݤ0=‡üÆYòÕVe àÊ¥$Ei¬f¶u¸î1Q$½+L'£]Eo$Mßu“ÂÔìüŸFÙg7%W[CLñÐ,¡ì—±qA0üÅ1¡·âä£@}rïùõŒsLéø9“KýýÜÊU¦áìBºxLŽr3‰ðd´«èë»nR˜žC~ãôÀK[Ð#m…se­fÈoÄd/ÖÍVŽ®)–eô:i®{&jv~‹ýÊ‚~-EW “!&§½£­Þþê­Þ•s­o ,Á4ÇJP¿(L4«ùm¿ŽÚ¶ÖJô«oûÏ­\iåü¡ùu«`A§w½‘c}×= =‡ü¦ÙÎo¥cè«ßÅ‚˜¬L#Ät Åb D7ˆ‰à«½‘4}×M S³ó[r²ÊÌœì—_FL¶´çlõïÆ Ä”mëëJqì“6?y*GÓ/mGëÿ ŠÕÀËÒ4â19¼“¥Û]aº¦X–Ñ9Öwݤ0=‡ü¦iÍoEÚ—x Ó1…·VŽ-ØtC~³|µ£7’¦ïºIajk~S´ß"‘kc/NIHJÞ®ŠÞ µ4"üøÉ*šùÐcüè0ž%¿Iü&šA¹$ð3ÇjÓ1¾{å\;é&ÇNF»ŠÞȱ¾ë&…é9ä7Ow~s¶Výõábàee!¦Ì×þí¥ºQä«»ŒÞHš¾ë&…©ÙùmpÉÇš»ögYîSòÑ âså`,©Tê1¹ƒÚaÀôÑ­Ü´æ·mÃ]М<ûY˜*Ó¨óû¥Zùº+gàæ&Ç.!ï2z#Çú®›¦çßµ|TJ2È&Ÿä˜dZóÛ5k¢íM•ŠK¼µi¤`ÉôFLïÔäò.£7r¬ïºIazù-Óä7 ±ζfí•i4%ÞsåQHî`öÅh—ÑIÓwݤ05;¿mf•TT„ׯ7½8¦`ÏSL>÷rQ] !Û•ã¸Qá7…išü–,)2_ù(ÈïÒ4BåLïS9+¿á&Ç.F»ŒÞȱ¾ë&…é9ä·Lw~ƒ§0¡71–ˆ©4ÔÂ{5{E5“F¯vî2z4×= “Þt~‡Œ~W¬6᪺€ïÁØ6tyñïñ“5³ííYˆŸT°ÔYòmc 9è%,ú˜*Ó1!_½rpG~ëÉhWÑ9ÖwÝ£0ésÈo%¿]Ìèl/P1Á¢6NLøý;¢ÂÝ\9=í*z#iú®›¦¶æ·ëm‡Ä¶þZX¼+í¯EìáXßtüd+Jà3|³óÉÂ4I~‹9í%~…ÿgSmäXÌá=‰'„t·ø½í:z#Çú®›¦çß:K~«ªm¬C Z\I©LƒÕ,§ø­Ç„pC~ëÉhWÑIÓwݤ0µ5¿1Åà„‹,OIñé&®çd… u¥ êà˜PmÝGâ׫öÉÂ4K~‹_Ûƒ€¸œ+Wšú9Yõ}»ÀÇSÜäØÉhWÑ9Öwݤ0=‡üÖYòÛ¯Mdòï;0»6õW3Û›ç÷jåîÄDOF»ŠÞHš¾ë&…©­ùM~[$ÀŒ«ˆÉ§*Yq1L°z*g?Ùû6\,6~VÁRg5¿½±J1ùU´T\¯LýóëÉï“_ÉwWRôò®¢7r¬ïºIazù­“ä·f_ÛýrV|Í5ù³ù­4õW3 ù½šQ wšßš¾ÚÑIÓwݤ0Ýi~[–GbocZU°Œ`2[!Æaå>Ë©ùí=ýâ×G§¤è$ù?{KJ™Ëů4zå^¼_š_ï¿üÕŽÞȱ¾ë&…é9ä·N’ßꀶÂút$.„â+ÓP]0¾OåRºCL)|µ£×I3pÝ£0¥›ÎïàòT, Þi¹ˆ˜Àg±՗Œš–ïÊ…ˆ‰”!„OžÊ¥YÍoԨȬÙ¦Ê4:•ËéÝùá6ÇâW;z#Çú®{¦ôò;Í’ß11£Ao~),+Ó¨+W»IànÿŸNF»ŠÞHš¾ë&…©ÝùlëéÒ¸ìÇ=K#Â1Ù âĹÚZÖcò+dÁ0…¬<}²0Ív~‹­-œm‡ihîçV®6N~]Üê:•KwÒºél箢7r¬ïºIazùfÉoW$ó$>UëgImžÊÅK]ЯÝÞ­f'£]Eo$Mßu“ÂÔîü¶½§äÌýzqoŒV˜$8JŒ®9´†˜œ.Qu…ô ãi™¿)LÓä7Ù 0. Siv~ã<&Ý #H£]FoäXßu“Âôò;M¼Lì7ªývˆ©2ÔQÞ'&·IsM±,£7’¦ïºIajv~ÛN6"Ûö€\¯uQÁÒ•+²_‘`]¹h‡ÇO¶U_ð`¿?;Œ Ív~[ cÉ*QË»r¥i„˜ ] >"ì†ÇLg;w½‘c}×M ÓsÈï4ÝùmÐ"E" å\¹Ò4ÒÊIßSRäV)]íÜeôFÒô]7)LmÍo×ö›Ìì—i–Úþú·L¶wõ#ûDm·‡o²¡˜Ä‡©Â1/å“…iºó›}:‚ß|ɼýÉc–¦b"ºÞ |w3]íÜeôFŽõ]7)LÏ!¿Ólç·{…C21—“x+Ó1)ë1Ñ]çw>Û¹«èuÒ \÷(L¹Ýùrö{V%ìÿ] ‰àhÞdoH)`Ž+…éøÉ¶( -þŸìcʳß|!f B(®2 ïcÂûä×>››Â”Ïvî*z#Çú®{¦üò;Ï’ßä'H€AK¡¸Ê4:•£øÇ””;¯|2ÚUôFÒô]7)LmÍïtÌPûCxñ®…ˆ¼¹2øÐŽUÄÄ\q<»ÎÀG Ó4ùí·°ˆ-çÊU¦b2(xåXNñf+—/F»ŒÞȱ¾ë&…é9äwžÖü&ÑxŒGJPŽo*M#=æ$ï ·«Ù%ä]Fo$Mßu“ÂÔÖüNŠQÈ0ùÀîÕÎoƒLöÞåìª¼Š˜42'öÍt_þMaš&¿c´„ôìo* Si#¦·Jª¾É±‹Ñ.£7r¬ïºIazùgÉoäÌ!x+¤¢0U¦áÌ/zk~k Ù“,_íè¤é»nR˜ÚšßªQÐo«‹¸ˆÔRa«*®­ <éÐL¡Ĥb°d8þóÉÂ4K~ûÛCé±hI©McŽéÍcºŠÞMŽŒv½‘c}×M ÓsÈï§Ó¶‹íàÍ‘ª‘|´ÜRaòŸlX‰ Ym¥ûMaš%¿’_st½…bàEmžÊÑ7b 7“x0œŒv½‘c}×M ÓcÈïóó'Mb§û@bLPJRT¦bŠñûT®“4'£]Eo$Mßu“ÂÔìüVo¹²‘8åÚ~"&µk¶½°O:ƒ“=(!"Dö™"Ÿ,LÓ/mO)~ -+Å+Ó1!¾URýVàMŽ]S,Ëèë»nR˜C~ŸŸ÷8i’kpâKE1‰·2 “½—³=ªw…éjç.£7’¦ïºIajk~'6¤'’„¼:"\}êp6D`Ey1‰÷0Û§¶+ÑðÑÂ4+{âí 1ØÎÖÅ© T^šFˆé¥Zyª¤æ»;µLªèë»nR˜C~ŸŸ÷DÒd²·Þ/ eïÆû‘4•i„˜ô$&1AhŸÊa<í*z4×= Slv~‹¨Ÿ©ù¥¦°È1ù¾5'¡a±É~r`tÍÏ•>¹•‹³ß$ɶùÂÑuÈ ÄTšFˆ)àûTNn¿x¶sWÑ9ÖwÝ£0Åçßq–üö7ºŠÂT™ˆ‰bxO°ñ¦ ãÉhWÑIÓwݤ0µ5¿Ùå˜Ðvr¶¥ËKêáoœEŽyÿî¾t¹™Göyüc:Hl$ÞÿÅ. UÉÇÜy¿P£NO/1€Q¶„J&“ €ŠïñM;ŒÉžÉgª{¬oŠßqQü6pÍ9‰½ùšR1‰§2Í“O=ÿÔÊq»\#þ´£7rlìz0=GüŽ«â·RÒ—ÎJ*¡dL…i˜ ã/cʱ·šÑO;z#iÆ®‡S§ç·“€·ë˜ Å^“m»YÇdO6HRôBËonåâzå·’+^‘SÑÁ¢6M5¦ð{3u®¤`ü”sÑ96v=˜ž#~Çõ¶'öý?Q{oÄþ´=)L3Æ”ÿsó›¸Ç˜>½LŠè¤»Lížß ~—ÖhSÆ„›âÈ ¼4 Õ­­ÜûÉÑ6Òd˜¿ L«âwÒ7}ô~0U¦cRùtI5\ê” ÄKÑ®¢7rlìz0=GüŽ«â7ûøQ{ï9Âdeš0&2¿{5³÷±§1]Šv½‘4c×C€©Ýó;ÚòkˆJö?h˜ü¼I^W烼ì0&{`ö»vká›­u¯¯gžcI˜]ÌWÿ…þ.~µi:»ã¯Æ$½Åï*箢7rlìz0=GüŽ«â7øôíHA½uí_`ªLÆÄøÛ]0pg!Â¥hWÑ뤙¸žLЬü#;h´Q3% ÍS9È )¿H1îjLJ¶•ó©¼ÀÕþ˜`Uü¶ćQ-Ë*ÓlÚ3Ãçä7Eí0&¸í*z#ÇÆ®gZQ4ÇEoeš1&†ßÜxÈ?íè»LÏ¿qUüNÞù>úTéPnå*ÓŒ11ÿîÿ™{ŒéR´«è¤»LÍÊo&%o?é½·SؼÄk›@¿Éâÿ¶Áجc²'³a¹²w°Œ_ÝÊ-‹ß~ì ïQÆ7¦cÒðŸž_Ø)°Ä[Ñ.£7rlìz0=GüÆUñÛǶæèSH —-)JÓLcÒßî*ÐÓ˜.E»ŠÞHš±ë!ÀÔ¬üf£KÉŸ½ÄrsAÁ/ò mv°'ûlðø™ùU`Z®üV§Á{-„¢À²2M“Ÿu~SŽ¼Ë¹Ëè»LÏ¿qyà%øù¨Ÿik1¾¹6ÍNåþ³š)…NÝS,ËèuÒL\Ï&jV~sBÈh@j¿¶Ðæ%^ï.#EPïÇ$›Œ)!ú^õqZ雕ߴ,~£øÜ6PѲV®4Í&ñ@ü­câΈ0¤[Ñ.£7rlìz0ÑsÄoZ¿è5K:ÅP6Š+MÆ$ ÿ9•ë] [Ñ.£7’fìz05+¿}.j¶T§,²ÙZW•rz»ïàɞlï–=Ï!ñ_€iUüök„)0ÀT™fŒ‰ã¯Æ$©SùMøÓŽÞȱ±ë!Àôñ›–^úñhJÞV4Âdeš1¦»íIx͘ëhLtO±,£7’fìz0µ+¿ääçõloÏ|nq*çí…0FA{ý×øº+§düþ0µQ­V~¿j´)‰ŒZΕ+M³Iì>S£¦Ò4YÍêoËÐkIA·¢]Fo$ÍØõ`jW~kÐHì¿ý¶Ü&cÃ`U[ÆÉ–ñùâ/Iý.JÎ!F¿`ñM`Z¿˜ôݽlW™fŒ øÃʽC'Ç.E»ŠÞȱ±ë!Àôñ›–^ÚÒ%Æd mÁ˜*ÓŒ1Ý-)|5‹¹#~ó=ŲŒ^'ÍÄõ `âvå·7)÷û ¶]¸±V2&%ûÇò=ÆdO¶m‰·= ¢ù›â7¯Šß|`iˆÄEåwešõ•¿så K:uL|)ÚUôFŽ]Ï&~ŽøÍËmO8$[žm‘(ú1U¦cJ1ý2¦žÆÄw/“2z#iÆ®‡S§ò;#fôÚ.û7/ñF@ǵ@ÙEÿ­­ÜëÉ~9È»gŠí¿ LË/sÞãß{T[¹Ê4cL!Ý9†>Ù¤“c÷Ë2z#ÇÆ®‡ÓsÄo^n{’…“RŽ9Cq] 2MV³¬xkLÞÔ­—4w/“2z#iÆ®‡S»ò;Ùêë]ÞÍíKÆ”8'W¾Ñ(׆rþ¾+‡à—Qbô¢Ô¯2¦åžßHÞi˜•€‹I¼•i:»ðWÇÌÚëùÍw#ï2z#ÇÆ®‡ÓsÄo^®ü~l'H´xY™fŒI?¿#Ú Ù£Ùw9w½‘4c×C€©]ùÍ‚Ÿ®ùÑlÈDcBÑ'æÀí/ñýäˆjä•S¯6ŠãUñûÕé/1»èUv(MSé·»@ÒîVîR´«è»LÏ¿yyà%Ǥ^ï§ñ…ÆTšfŒ)&ñR`íiL÷Ë2z#iÆ®‡S»ò›}tB2™Œ1íŸÊ1aò;¥¬¼y*gOÎN˜ˆ¢=|º‰ü`Z¿S$¿Ì¶=­º ”¦Ù©\þ+÷ºGØÎ±KÑ®¢7rlìz0=GüæåÊï(I½äÆ « ©4MV3oPöјt® È]Î]F¯“fâz0I»ò›%äÈÙ¶ŸtWcŠ h»añF/º«1±ªDçky>ø€I–Åoâ”} '¿'ÁýWü.M3ƤôéùeŸo/ÇnE»ŒÞȱ±ëÀ$Ï¿eUüö©mQU1D- ,+Óx5s…:ÜŒÉ~¶S•+—¢]Eo$ÍØõ`jW~³1d` ¯ò®ÍÖº(™íU1¤{â÷ëÉ~ —2¦ìÝú¾L«â·nIÞ= ”,KÓŒ1¥ß–)÷®=É¥hWÑ96v=˜ž#~˪ø£¤×;Ÿ‹ –•i¼šqøùe8Ò;•“KÑ®¢7’fìz05+¿Y4%fß D‘­))ÿ÷?ï Q\Í6{~Û“•!QŠìuߦUñûuC£ý+מjÓ„1Áï´gÌz‹ß¥hWÑ96v=˜ž#~ËrÏoõ;Yb´8HqW®2MV3…ô{*Gй+'w#ï2z#iÆ®‡S»ç·D!Cö“¹°Ù] ÛÒ¼ø›€øÕRi«»ø¼K !¶üf¹€,¼Œbßž} ¹¼Ä[šfÓžéÏ©\Gü–{Še½‘cc×C€é9â·¬Šß)²½÷àã‘ÿSešiLŠ¿uL¹7%UòO;z#iÆ®‡S»ò›#Ebè¼Û(îÿþ— †3Ù΂ƒ‘ÄÍI¼ìµ¨¶ÍIÑ}³\@–ÅïRÊ9$¿,SSišäX|ž¿4¦Ücå·¢]Fo䨨õ`zŽø-Ë=¿Õë^ì ¡˜Ë»r¥i¢1Åïª\²õ§“4énä]F¯“fâz0¥vå·©m¨¼f=ywŽ-ÆÄ)h&[º“—YnNâeïÂä}õý1~ScJ‹âw´5E)ƒhø[ÇT›fŒ‰ó/cíœÊ¥øÓŽÞȱ±ëÀ”ž#~§Uñ[¢wùRµ=©L3Æôß¹r:7¿Ó¥hWÑI3v=˜º=¿Ù˜QT˜ßXû˘¼ÍgŸW /ñ{¯ç7jð°Á7·riYü6òÂÑgQ[¹Ê4É1Dùí+ØÙÊ¥[Ñ.£7rlìz0=GüNËmOÀ›æçìÉŠrÊ4=•£_ÆÔFî^&eôFÒŒ]¦vå·ý#~ÁŸ¼_Üî]9ŽŽM‘5&M[â^OΨ½Å®Æo^âM«=¿ƒw; >S,`qí©2M¾Ûé¾ïÊaîÜ.HW#ï*z#ÇÆ®‡ÓsÄï´*~ÛaÛja{ë a²6Í“àowØ»’’.E»ŠÞHš±ë!ÀÔ®üNY ˜” Iئ”¼l;)±áK;ã›üÉÆ$ð5È•ÜoÓ¢ø£{Á> ûÕJ¹ 4ÍúÊë5TõÅÊ»9–~ÚÑ96v=˜ž#~§Uñ›üœ”’a IÑö¤2Í*¿‘?ݲ¦cºí*z#iÆ®‡S»ò[CæÄ†Nx÷J ¨·8Ï>éÞwåv“ÆÈˆÈ~ƒ¯#H«â·íÁEƒ€Pu*W™f}åóïcbO.¸í*z#ÇÆ®‡ÓsÄï´\ùí§7š½€£ìÇT™¦Œéwæ—j¯ø-ßåÜeô:i&®gSnW~çÑ'~po1&òËʶcLšÂ¦Æ”ƒýÔ«ÄÂÏæ¾Lyµò[|•ú5%¥¢ò»2MS”ߣ^Ž]åÜUôFŽ]Ϧüñ;/Šß^XÄ–W{¸8Ê­L3 ôÞÿÄï ?í褻Lžß^¤Ì¢¶¥¸9Œ eÆ"‹m]¶Äïד½¨°B˜—vþ 0-¼ô¾R†µÆáÊa•iÖó+Âï}Lß©¶sìžbYFo䨨õ`zŽøWÅoAòBãàC ñ»2MV³œù÷Ä$ôhv¾í*z#iÆ®‡S»ò;ˆ&õNžû–êݜįG€ý÷î\9/DôiÄyk‚¦ÕÊo[Vlg ~R)Å•”Ê4ë+ŸÒçvÿ»Ê¹«è»LÏ¿óªøÍ€Q‘Õ^¤TÔ˜T¦cÂ>«Y„NI¾í*z#iÆ®‡S»ò›Y|Ô‰J Û#Âct‰¼=íÌ~ºNå|.¹í ½‘ÕôÉÿLË/#*ád5ð¢6M§= Ü:¦gîäØ=ŲŒÞȱ±ë!Àôñ;/÷ü6új«zʉãߤ©M“»rl\•ß½{Lùnä]Fo$ÍØõ`êT~köãlÛ‚‚Äݶ'ˆÑ)GBbØ8Ò»ê˜À'i¹d’¾Z.WÅïȯÊ*‰¹hW™fŒ 㯎)Ô™+—/E»ŠÞȱ±ë!Àôñ;¯¼Œ˜C¤(\ìÿkÓ„1AŸý¿ýtG˜ÔÏË"z4×3€IەߤޮÛßÄ;M(_Œ‰4$´«·¯w.)Áhk¿!ÔI—ÅïDÉ^x¢cY`YšfuLúÛ] cì“ÞŠv½‘cc×3€IŸ#~ërÛ“„„AÕÞùb®|mš0&¤üaL¹Ã˜ôîeRFo$ÍØõ`êU~ÛT|N§âNK¥cJðšê«xÚ™ýt1¦¬œrNjðôÍÊo]¿³!,ˆF%Ÿ\þ7Ç*ÓìTNâGÇÌқīøÓŽÞȱ±ë!Àôñ[WÅoN”ÙØˆ ú«1•¦cÂÿ0& N/½í*z#iÆ®‡S»ò[24øÅãÄ{SRŒ1²øVNÒ–@õî.Å&a£ðÍÖºº*~«wÕô6 Æq ñ»2Íê˜büo­\çTN/E»ŠÞȱ±ë!Àôñ[7*¿U"zïz*/X–¦ c¦{5󶮪\ý-çþ½‘4c×C€©Sùíð¾À›—x!RFsaoÁëɾD@Ê”ãW/ñêjåw0„Tõß'”,*Ó„1ùöôWcê5#ÔôÓŽÞȱ±ë!Àôñ[×{~‡mæE/’¦2ͺ p¼û1“‚ï$ͧ‘w½‘4c×C€©]ù³ŸÀ\zÛ«üv?‡4ÁvÏo¯«pÇ„qÞ×à_€iUü–L0E­ë˜*Ó„1¥øÑ˜¼°­S. úÓŽÞȱ±ë!Àôñ[WÅoѵeòY¤ÅV®2ÍNå’þvàÎ%^ —¢]E¯’fæz0QýÕ]Œ)%yIßêI{ŒÉ¨¡-á!§íñMþdÃ5#—è ú7O宯gžcɸ1Øw©¸+W›f§rùs5vÆÐS¸y—Ñ96v=˜(ïyÒØ‚.ì³ýSQ.P™&ŒÉͧ»äÎ —¢]Eo$ÍØõ`jW~§dœÇ'^Ú>”6OåŒdQ$÷œÒNk‚÷\¹Å©eö“¦¯Óªøm|D__4Ö—x ÓLc"ý’bÐÝÉ1üiGo䨨õ`zŒø}}Þó¤±e=eŸØN±¨1©LÓS¹O?fŠÒ9Ê5þÓŽÞHš±ë!ÀÔ¬ü°C“­ðÞÁd ˜Œ1mÅø(¶?}1Ù“Éoð¡ñšß¦Õ¶'ÆàŒ6Ú{ÏRŒ¯M³ÛûÊ¿—©VŽñO;z#ÇÆ®‡ÓcÄïëó^HˆÌÉòŸA¨XÍ*Ó¬ò›» (†ö‰ …[Ñ.£7’fìz05+¿Åð1ºüýj‰¸Ç˜1è«á[âywÜ¿IcOÎJÄÞ3˜o"ÿ˜–+¿E0J!e*îcV¦YŽ…ßî©Lw9w½‘cc×C€é1â÷õy/$MâÁ˜¼%AÁ˜JÓlJ òïÍïй`I!ÿ´£7’fìz05+¿“ëa^ŒämvHÏ‹1‡ÆÅkÃ6ë˜R´‰ï¤cøæ””ëëYÈ1޾)õ¤4ø7Ç*ÓLÇdù°r¤Î´g —¢]Eo䨨õ`zŒø}}Þó¤É”Ч½ªQÙPÐìÊ4›’5}öÿ]`ŠŸ^&Eô:i&®gSlV~'?w¦d™Ž~ì¿É˜ gÊb;2@ ?Œï'»Àeß…hœ·¨û`Š«â·/Y^ôs(‡T¦)+§;Ç;rAŒ?í軞Lñ9âw\¿}0úÞ!QÙZ·2ÍS„»» f‘v%ÅKÑ®¢7’fìz05+¿Sö1eÁuhKõÍÖº4€¢3ÓüVIÁ˜ÑŒo%¿C<ò¿ÓrÛ“ØöJ(S9W®4M'ñèçvAìMâ¡x÷2)£7rlìz0=GüŽ«â·m5Ð81æWwŽ¿U¹¥iƘòo?fûŸí¶'/E»ŠÞHš±ë!ÀÔ¬ü΂^ªîmOTe·ò[½U©$ÛÉÍGÃýMÃ¥`?Ù›Åâ7·rqYüæd+KeIEIJešÕʽ벯“ßØÑ˜â­h—Ñ96v=˜ž#~ÇEñ;i"Hl•Í `*M“Õ,qø0&!é“ü´£7’fìz05+¿•ÁÈ’ŸkκÛ]Àù¦…1‚ˆ; ÃñýdQôþU¶‰œÏgù`Ú¿)k0êK©˜ö\™æ÷1?‘vjå⯢ý7z#ÇÆ®‡ÓsÄï¸Zù-1Fß))‡ªQ\išu$úôÊ1ºÐÛÊ]åÜUôFÒŒ]¦få·ZŽGï+#n•"½SòV Fz˜cö“75ï›QX¾x%åúzæ9–¼a»Ï¸ó±€ÅâW™¦÷1á>ù%¤Î$^Š·¢]Fo䨨õ`zŽøWÅo${{‚7-Smš1&H÷ïhë|g´Á¥hWÑ뤙¸žLЬüŽÞòujìÇà¡“JMÆÄÆ·Œqñëxn«Àòõd¶_!ÙfîUÇ4|ò?,W~{:ÜVÀT™¦· 2ߌ rïvÜåÜeôFŽ]Ï&xŽø Ë/3h&Ì Åצٔ” áfL –÷Ë2z#iÆ®‡S³ò;ŸÍl{kû±WÛîe`ò~L~ L¢‘Ÿ¤»ý˜b`{¹^…LÊ"ߦUñÁþ 0ŒŽï9:®¤¦™Ž™øSÇdŸqGüüiGo䨨õ`zŽø Ë=¿£¦Á¾ðK`*M³S¹ð{ó;©vh6ܼË褻LÍÊï¼¢fC‰4å-cÃb%É9FÖÍS9²w>1B“rÒoÓjÛ£»ÄÇÝSR*ÓŒ•ë§ç·m»z,põ2©¢7rlìz0=Gü†ÕÊooâ ` +`,ZRT¦Y‰†Æ”¹W• W9w½‘4c×C€©Yùm+F¶!óöÛ¦ðPöüö!º˜ì5Éigö^OVÛò²¯ ¾ LëmO‚ŸúÙPÜ.¨L3Vþ;%Å€©§c§—I½‘cc×C€é9â7,÷üöÖ¯¶íÖ”ÔÂ4­1Ïj–Rïæ7ܼË褻LÍÊïA(a0Þ“T¶€É±íýpõÛ"Ðfå·=9…('†¯jL«â·ú¿ÞsÁ˜*Ó,Çøs»€B÷Tô§½‘cc×C€é9â7¬Šß~¬> `ªL³Õ,ñg5“”:U¹x)ÚUô:i&®g6+¿£_•ó&Rè,Ó&c Y|`‡íí/߬üö'g/UÐðE`ÂåžßHE)û¿ÀT™fðoϯØFx7ò.£7rlìz0ásÄo\¿ýîƒù+†Jü.MSÆ”>,’ôŠßðV´Ë褻LÍÊïø*B2|P#04ÝPŒ)€¤à40ç­­ÜëÉý0@ø20-‹ß”(²ø¸ø·À²6ͺ ¼[6_ý˜z:&ÞŠv½‘cc×C€é9â7®Šß û”{,ÛžV¦YU®ê}bboDïÄ/E»ŠÞHš±ë!ÀÔ¬üŽF–bH^%i{«-ñûÿþg.k‚ÈdobÜ›ÄëOÖ„Ñ;`æoÓªømgšÅgI`=‰·0Í:X2üꘔړx/E»ŠÞȱ±ë!ÀôñWÅo?ı¥"Ø‚Q2¦Ê4«1þ0¦œºŒéR´«è¤»LÍÊïˆâcƒƒ÷öAe[ŒÉG¢£±½(>Rwo¯mòN±à-,ó7Oåpµò[3‚€8£Æ¢Ž©2Íëï\9€ÞVî*箢7rlìz0=GüÆåÊoð}ßë>šSešNâ…OwÛ³÷’æ.ç.£7’fìz05+¿£í;Å~mdË÷=ÆäÅ)1e<ûjM°Ã˜Ð¥%UõaZAõ/À´Þör¿Ø¡h­S™f:¦|úÊÛV:E¼øéeRDo䨨õ`zŽøË•ß Â¾Àz?š¿ÀT™¦U¹¿5&Y°s”Kw9w½Nš‰ëÀDíÊo (>7*ì2&ãZ"b;W/ÎäMÆD~&Ë1€ïK¾É˜hUü~Íßv6bô±ØÊU¦c ôéù•¹3T•(þ´£7rlìz0ÑsÄoZîùP½’Ͼq.^V¦©Æôé.hÀÔ;•£»‘w½‘4c×C€©]ùMäÍG¼>ÒpojLfó~ ¶ˆƒ¼HÏc"ò³<¯JeûJ¾ L«â·x¯Œcy‰·4ÍÉz~K/Ç.E»ŠÞȱ±ë!Àôñ›VÅïL9Û¢.hïÂß¶'µiƘ”ïßÑß‹N ]Šv½‘4c×C€©]ùMà;©È ’Q‹=Ƥ$AƒÐx)ç[Œ ¨eö Žù›[9Zm{$& ÙdŠÅEñÊ4«üŽúaLÉ»º´sìêeREo䨨õ`zŽøM«â7Çè·¹ì¥(€©2Ín~óï\y{¯zÀt)ÚUôFÒŒ]¦vå7%$Ÿi®EïÖ1¹`ÎÞlßG£oÖ1QÊÞf.zsÝÄߦUñ3:ÄX U­M³S¹ü«1å;E¼t)ÚUôFŽ]¦çˆß´*~Û0ØJÄ’ŠS¹Ê4aLùÓ]0@èˆßt)ÚUôFÒŒ]¦vå·‘<Ûk¤æ¸Û] Øg©¯îºêªÚ^Ó»­‚-N‰¿Y.@‹âwöÏ@Á b!T¦cÂOKL,=Ƥ?íè»LÏ¿iUüŽI½¨Ì¹?•ÝKÓŒ1iüeL¶i' ‡Ÿvô:i&®g·+¿½"o!˜o¨Ê»rà-(Ù°Íïöl2&–ìMˆ½`æ\퀉—+¿sðæ£Þº¶ªü.MÓ¾òé·Žéݧ•cw9w½‘cc×3€‰Ÿ#~ó¢øÔ¡˜mÇQ¬fµi˜Àû{ÜSî]âeøiGo$ÍØõ`jW~ C&ñÒJÛwå %#‰¨>lvÚ„²`Lâׇ³·ÕM®˜–{~'R@ŒÀRÞ•«L³ÿéù¥;Œ‰ïFÞeôFŽ]¦çˆß¼*~+ IH8ÿÝÿצ٩\Ä{/úÂÓIšKÑ®¢7’fìz0µ+¿%¼…íõ}7¸ÝÒ˜$f[ÃÑ€8‡-`z?9+ùÆ$Høfw^­ü¦“9•‹E_ùÊ4eLò˘„:WRø*箢7rlìz0=GüæåÊo¯ ˆïnJÿÝÊ•¦Y?æ?û„ÓIš»œ»ŒÞHš±ë!ÀÔ®ü–Ðç覰¯1…àb,{‡¼½áï'+»²•ƒò7Ëx¹òÛÛBBŒÞ^ªxQšf÷1CúôüÊ$kO|—s—Ñ96v=˜ž#~ó²øíÓb} 9ýÝÿצ™Æt·=}Õ˜ôŠßøV´Ë褻LíÊoŸœÀŠÑ°…óôl¬¨c2ª/Ù†ŽÒvå·•Q0’1Í!ñ_€i¹íIô±€ÞîÀ~«˜JÓt/}X¹ÆîVîîeRFo䨨õ`zŽøÍË•ßÑÙHNÁ'Jþ¦Ê4­cŠw?fŸ¶ÜYÍä.ç.£×I3q=˜¤]ù퓺ÙÛ–H¼U`éó#ö˼ú*Ø©cAòöúè›uL²*~ç%rÎößZSešiLï*£‹•c§\@.E»ŠÞȱ±ëÀ$Ï¿eµò;ˆl•MPž˜Ô¦™Æ$¿SRRêÝüøiGo$ÍØõ`jW~‹Ú'`¨Ä¶¡š×_W“Ÿ¬q²íœìNI±'gBCE¡H_í`)«âw$a1Ƕ/Nå*Ó,Ç’Ü=¿ µ{§rr)ÚUôFŽ]¦çˆß²ÜöÄâHL rYcR™f§r'ñbo‚…ܽLÊ褻LíÊoƒQ‘èíí€÷Úž¸Æämq š"Ó0½žl3ûFÒçø~˜–Ûž† ¿&‘¼îü—1•¦câða廋ßÝˤŒÞȱ±ë!Àôñ[VÅo2òÊ` ;ý˜*Ól5ËüÛ] ÷ ,åR´«è¤»LíÊoa5yÓÖÝ»r1û€pŠÓÎ|q¼žìWäAs’y¡Â¿Óªømü=£$?l 0U¦™Æ$éWc‚^k¹í*z#ÇÆ®‡ÓsÄoY¿½‘DðþÔõÀËÊ4cLþsó;tZRÈ¥hWÑI3v=˜Ú•ßFð8kRŸ4¯¿®ê˜²F´?9ÀvSô^LFÐWÅɲøbôV,X2¦Ê4;•úíù…±ÓÁBnE»ŒÞȱ±ë!Àôñ[–{~Û‚ž}…ÆT™f§rÿ½Ç„¹#~§»‘w½Nš‰ëÀ”Ú•ß¶ Á¸Kðî[åΘ‚xé<ûåeØFð~²1¦ÀèZøæ]¹´\ùí_ìó@5&ÿ˜*Ó´Ž)|úÊ+ïˆßé.ç.£7rlìz0¥çˆßiUü6úš}³–Ý*Ó쮜àGcÒnñ[ºí*z#iÆ®‡S§ò;’1¼ìwyl]Iy1&Û[hˆ`LñÕ¶{1qŒäU~_þ›À´*~³ßܧ˜E‹ÊïÊ4ëǤô;»sGÇL—¢]Eo䨨õ`zŽøÅoY(2[œKš]š&ŒÉ$Ü;i¤ù¡}Á˜H‘™l O›Œ)‚Q ?±Ê~Áâ‹À¤ë=¿"ûI€”WR*ÓŒ1iŽƄڑ ôÓÈ»ˆÞȱ±ëÀ¤Ï¿uUü¦€)!xÝkÓ¬*×Vœ›1åîÐl½í*z#iÆ®‡S³òÛÖ^¯€7lÙj÷ºU’}B¸åÊi ˜^O¦à-¬1yÓïoÓªøm &4‡å\¹Ú4»]@騂ö¦=ë¥hWÑ96v=˜ž#~ëjÛ"Foõ9•#Â+ÓLcJú9•óë#¤¡ŸvôFÒŒ]¦få7ØþMS°TIö^z¤ZHÅ~ééUÅ«þžÊÕ¦™ÆdßîGczŸž´’æ­h×ÑI3v=˜š•ß¼Ù7çÉ ¶û1娠½àï}°¶Ã˜ü0ƒmt²ï¿ L«âwB/ò*öXŠß•iVùõ·çW "^½í*z#ÇÆ®‡ÓsÄo]­üoߪQmÓPÖ1U¦iËß™_~½½“4W9w½‘4c×C€©Yù ÞQ7EFõ&ûŒÉ'/úMûÓ!l]â}=9#eÂÈá«§rºÜö„9{i•Sœ¿åµiÖ)þ§KjwÞ½LÊè»LÏ¿uYü¶5݇ªú|ˆroišöüŸÕL´3ð’íh—Ñ«¤™¹L\uoÆ”UT@)pÊ›såüÄߨN²Ÿ¶=ìÖ%^²3Ì$"J)±µîõõÌs,©az½(TŒ©2Ír,üv°°œhË_?íè»L#~_Ÿ÷ËÀ[뾇Ò} ˜–{~'&ôë“®9Všf· |N~³íw;9v7ò.£7rlìz0=Fü¾>ïyÒd¶ï„½åq.:XV¦ùþ?Ü«¿Ûmµ’æ*箢7’fìz0µ+¿£½C~ÇOlƒ¶Å9¶xå Ù«ò¾¼UÇäuß‘mSâ­b¾ L«â·ý5à“”É¶¸+W™f§r!ýv°N_yãU?íè»L¿¯Ï{ž4Ù¶_àãƒæj|SišöÊ‘Ï æØ>1áp)ÚUôFÒŒ]¦vå7ød9?›ãL[—x [ìd£1Ž+)¯''4×à¿(~__Ï<Ç’]&Hö ær+W™fwåâ臭b—•_Šv½‘cc×C€é1â÷õy/$M†lcT)”[¹Ò4cLÄŸžßüžfÑHš~ÚÑ뤙¸žL±]ùíóØP)ˆ¥üfKðÔ¶kU—‹ö ,_OfcMÑ;1ʼáÊ?S\¿Ù¯-–ZäXešõü"ühLJ½­\¼í*z#ÇÆ®gS|ŽøWÅo ‘lß I˹r¥iVÇ¿Œ‰Rn×1q¼í*z#iÆ®‡S»òR$ ãfå7„³7z5’w¢7ŠÁEüæ©\\®üNT"©æ"ÇjÓ”1%ü0&/kçØ]Î]Fo䨨õ`zŽø×^Ú×áKc,hvmšjL¿,liëlåâgŠe½‘4c×C€©]ùí—®²×ûljLQ}[,j{XͲ}WN©ÙlÄ)ÌÇ ü 0­Šßò:ŠñÀ’•W¦©Æ¤Ÿ“ߌÔ9•‹—¢]Eo䨨õ`zŽø—Ûž¥àwdƒ–Ý+ÓŒ1½e÷ÆôÖ›ZIs÷2)£7’fìz0µ+¿£Æ@á5 /íX¾.á _p¶Eº[ùmONÄ!ûÐöoÓråwÖ…“_±)¦¤T¦ÙÉoN¿§r±Óó‹ã]Î]Fo䨨õ`zŽø—ÅïœÉþ¥èZm!~—¦i?¦ðYÍè=ü²•4·¢]Fo$ÍØõ`jW~ûeP¶Íœ m9v;X¦œR$  ÑÖVîýd{ÃŒ_:ŽUcZn{bëd?ÝáoŽÕ¦é]¹øaåYº‹ßÝˤŒÞȱ±ë!Àôñ;®V~Kˆ~¡l{R™¦ÿvN?f#ã?íèuÒL\Ï&hW~Û†ÊXž&#=yo¿&äÓüÖrØì`iOTÍÄö=SHü`‚՞߆±b[[VÁ…\P™fŒ)釕{£ÎNŽ]¼«è»žLðñÖÛžPöÖ®áTmO Ó¬þNâ5šÐaLðéeRDo$ÍØõ`jW~1Û˃’tKüöy¢>Q•ó»j‹1Ù>²·‚Òo2&X¿ÅV)/‘U#‚…ø]™fŒéFàŒ‰¡SÇ—¢]Eo䨨õ`zŽø Ë•ß~2 y»Ä¢Æ¤2Íú1‘~NLè !­¤¹Ë¹Ë褻LíÊo°Í``N~'e÷T.²7òÂÒ@»wåìÉ9Ñòë0øÅî×׳’c~“ÄöJ)PѾ¹6ÍNå’Üï­}a w9w½‘cc×C€é9â7¬Šß>Ôû‘E)Seš0&‘ü¹ùí§“4—¢]Eo$ÍØõ`jW~C ¿$èÌizc­¼+g+8¨1‡Ía¯'3dCCðwí›–°Üó;FÌjþ1Ř*ÓŒ1Á¯Žé}:9v7ò.£7rlìz0=Gü†eñ[¼NÍ/ a..ñV¦cBþìÿ1w“æV´Ë褻LžßJ(ìc@ÏôMÆäSfØÚáÿCcò¤>š<}•1­Šß‰XíoIY¤xY™æ“x~§=#í䨥hWÑ96v=˜ž#~êø-~+ Pí=¿-)jÓ„1%ü­1Áˆâ7¼í*z4×3€ Û•ß‘¢&Bõ9)¸{*g¯ˆ¡ZÛ˜ív°´Š³Fß#V¾L¸,~³mÀäx øú¯ø]šf,l7çX"ê°r¼í2z#ÇÆ®g>GüÆUñmi%4–'&•i˜Œ×|¦¤ØZÝKšKÑ®¢7’fìz0uz~ Šmä5`·ç·z«Eã½)Ð6czIïêsÚ¿8"üúzæ9–”^ç“^ñ‘ŠrÊ4eLñ“c9h‡1!þ´£7rlìz0=GüÆÕÊﯙm.ˆ¼ˆñ·r¥i¦1|NLü"F'i®rî*z#iÆ®‡S»òÛ¯«¥ ”@çeŽc h~–`ŒÝ–à³d Œ¿*ScÂUñÛ‡.¡‘@ã$±ªc*L³»r9…;Ç4ÄÎ]9äŸvôFŽ]¦çˆß¸*~‹½9ö­¤ÈåV®4Mó臭wÞê$ü´£7’fìz0u*¿]bÊöh~c­dLë‰À^ÍÛÝ"cÊLAæ²û¿Órå·O+5*â YJ©4Mû1Ñ'ÇRŸ•ßåÜeôFŽ]¦çˆß¸>ð2‹zv_f š]šfŒ)„Ï$^ï<ÝIšÏË"z#iÆ®‡S»ò;*sÉÆZX6{~ƒ^H€^½íwïʉ÷|÷#Aˆ_xy}= 9f»Zeñ[Jå´çÚ4cLð;%%õÓ¥hWÑ96v=˜ž#~ãªøl;$ðµ¤å]¹Ò4cL!~º Ä÷ºÓHºí*z4×3€‰:•ßF9ø¸K¦½Ëð 'Á5ÈÞ¢x“1¥²ÈÙs烣þ˜hyà¥wãŒ1d:fmš1&ÉŸ:¦¤Ú)°¤{Še½‘cc×3€‰ž#~Órå·ï«ÑO·©º’Rš&ŒÉ/ËÝ«™×v’æ.ç.£7’fìz0µ+¿£x›ðºŽÑ›ý˜Œd1dC'yw.ÙbLòš'Cšs†oV~ÓªøÍB½AŲµnešÊiü°ò„½Ö:t)ÚUôFŽ]¦çˆß´.~›/[6WmOkÓŒ1aÊÆDÚ¹’BE»ˆÞHš±ë!ÀÔéùíP¿éo¿õnw0ÆãÓ.½…%Én?&ÿ¼›R„€ßÔ˜hyà%¥€!ˆoð˹r¥iƘÞ*ã›1qèÓ=ŲŒÞȱ±ë!Àôñ›–Åo¿"ÄèλµÛÅïÒ4cLð˘‚ôŽréV´Ë褻Lžß^ß@hÉ6ížÊôC5¶½Èî©\ÿ©¬H~÷›À´*~ÛŸ’íI}¸p±•«L3Æõؤ;Œ€.E»ŠÞȱ±ë!Àôñ›V+¿mSm‹DN šŠS¹Ê4Õ˜øS•¡wWŽ®rî*z#iÆ®‡S§ò-Ã_|É6T»§r†H!eÍ>·j—1qµÏÌ/Ãø|£/Ó¢øm ì ¾C-Yyašu°àüé`ÑCϤ?íè»LÏ¿i¹í‰¿9™-±81©MÆä0~5¦^ÛS¾{™”Ñ뤙¸žLÜ®ü6|P¢èº†ÝÌÈÁï»o×1ÑkRf4މßlÇË/Y_»ÒèXþ2¦Ê4ëù¥1Þ9Ɖ:rßS,Ë軞Lüñ›×{~ûläl+4»6MV3/€¼W³¥³•ãO#ï"z#iÆ®‡S»ò#±÷µŸd½©1…ˆâÓx9½úòv²¡É˜\ß5L ¯Š×/ÓªøF®Œ7²W!SešMâþœÊù§ÛɱKÑ®¢7rlìz0=GüæUñÛë7sJ±^™¦Œé·WNŒ=šÍ—¢]Eo$ÍØõ`êT~û O Þc ÏyË_ÆÄÁ>I4dañ)q;Àô~2ù zõ÷7OåxQüÎ`ß_´¿'j9¾©6Íz~Iú0&JÒ‘ ˜ÚÑ96v=˜ž#~óªø è3à|ÒÄrJJiš1&‚Ow ½ñÍ,?í褻LíÊoBƒ–(ÙÞ$Š»såPóØîÂvÄò&cò›Ã1³Ø¶äÝ—÷kÀ´*~+`ÎÈ¢>q©ØÊ•¦éìÂß–œ»rÁ¥hWÑ96v=˜ž#~óªøÍ¶×@öáAŠÕ¬2MV3$¾W3PM»r|)ÚUôFÒŒ]¦vå·×n³¥{ˆÆô¦ª¿Œ Aýšœú•ûŸöôÁ˜(¥€Þ*Ö/Ã|Süæå¶'è-U]‹··ÿ/0U¦©ÆŸS9¿ÝÖɱ»—I½‘cc×C€é9â7¯ŠßAB²u]ƒ½ú0U¦ cÂDŸý¿ß^m'„Ÿvô:i&®g“´+¿í¥±í¬xݞ̕ž¿À”ÙGÃý¯×~r11"%b¸«1ù¬ðêN2hüfSZ¿Á`R¼w í—Š­\eš1&åÆd)Ö˱KÑ®¢7rlìz0¥çˆßi]üÎ)¨7ïc)ÅW¦Éjfˆ»ä€Æ”>Šv½‘4c×C€©]ù}N¬p-zóTNìoMê}÷%!mmåÞOfƒ$ÛX‹·¯þ"0-‹ß)ÙžV%ñß»rµiƘ(|wrìV´Ëè»LϿӲø­ì€Ñþ«œ`Qš¦ŒI?§rƘ:G¹éV´Ë褻LíÊoKð¤–ã>Ûu¯\ üïU„¤!û–wÛ“Ƥ¶!1ž–\f¢oŠßi]üÆ”¼Þ“±œ+W™fuLŸiÏWcÂVŽ}í"z#ÇÆ®‡ÓsÄï´*~c Þ_Z½ú¥¦Ê4cLQî~Ì>ª±Sù.E»ŠÞHš±ë!ÀÔ®üVC%/$vùzoJÊÿýÏ‹rôërdoÜdLödÛÂa6>!ñ›såÒrÏo{٢햸FP™f³ º лª­•cw#ï2z#ÇÆ®‡ÓsÄï´*~ƒOF Þ†=”Ý*Óx5CMñ>1ñ£¡ÞþÿR´«è¤»LÍÊo ~Yۣͯ͗(„,1C™=ÆäO¶¯ß$ôBù/ÓrÏoo\}D0–ã›*Óô®Ü¯ÆD]ñ;ݼËè»LϿӪø½Û¡/˜°8•«LãÕÌçxß«ˆö ,ó¥hWÑ뤙¸žL¹YùÑû˜itIòV¹€1&}Q&M|:Ìc²'*a° "~˜òrÛ0§dFFÂ_`ªL3Æ”ïcbg+—ï^&eôFŽ]Ϧüñ;/¼ôNGDÉ~Ë­\iš0¦#ÜŒIö€éžbYFo$ÍØõ`jV~cTQ@ÉÞ ¶ ,Ãÿü\Í/¼ùe;¤MÉžì“®•1á7ïÊååžß˜Õv–ü@þ/0U¦cÊzçúåÌNŽÝ¼Ëè»LÏ¿óªø äÝ{ÐxñûŒãO?¦Â4aL^ùaL¡wb’é§½‘4c×C€©Yù>×H oA¶Ë˜|bGˆh~Ò¹©1ù““O¬1ÂFó¦¾ÿL«âwVõÿÉÛLŒ©2͆Oå·AI§S¾í*z#ÇÆ®‡ÓsÄï¼*~û»ãƒœûwå*Ó„1%ÈŸî¶Xw4¦|)ÚUôFÒŒ]¦få7úÍ>!:mš×_ÿMš”ÄÍ(ú4ß-`z?™lÙ'¿}³ƒe^¿sÈh0™S.¿Ú4;• ñs*GØëÇ”/E»ŠÞȱ±ë!Àôñ;¯Šßòê’ho½T,+Ó„1 |V3 ÷ü¯VÒ\Šv½‘4c×C€©Yùm'e»ƒhÚ›’òÿòI!®dû³w“.´ÿ4¢ö¾ü5`Z¿3[n`Ò¨ jÓŒ1¹ïc¢!~ç®\¾í*z#ÇÆ®‡ÓsÄï¼*~'ŒíÛ[Ëa¥i˜ÌùSÇD¬½í*z4×3€I›•ßhÐm?›¢ŸjoMIyMO3žF ŒÓæ]92Úëe۸೾Lº*~“qÛ_úù$#Â+Ó„1¥ð9ùE¯®ï䨥hWÑ96v=˜ô9â·.‹ß!y VEŸQYˆß¥i˜RÈ÷\9`èoÖ[Ñ.£7’fìz05+¿}<'ú^MÃö]¹äÑR²·D_#Vö4&eÊ>úI$}ScÒEñÛ¶¤9û¯•¡Ð1+Ó„1IàÏìBŸÚ×É1üiGo䨨õ`zŽø­«â7@ š™ ^™&Œ‰3Nås§ò[/E»ŠÞHš±ë!ÀÔ¬üö«}F)X”üÙìÇ$"HöŠ$¾&0m1¦ìº7*9ßú橜®Šß®'GÉ^.ŠekÝÒ4aL¿³ cG.ÐKÑ®¢7rlìz0=GüÖåÊo[[##k¶µ½`L¥i˜ü-ºjî“z—s—ÑI3v=˜š•߈Á`½ú;EÞß”}FŸÏ„õC9ÿaÙ`L>¡Æ€‘rú.cZ¿I“Œ!ÛçâT®2ÍÿÖ1ùMåNŽ]Šv½‘cc×C€é9â·®Šß¨B™|àD(§¤T¦c¢ß:& ÜÛÊ]Šv½‘4c×C€©]ù ¤ÙaõÙ±óæ#e£¸À‘Œrí ÛuLödõãÑÞ±ùe˜¦åžßÁço‹}¹xQ›f“x~ûÊc”Ô)IÑ»‘w½‘cc×C€é9â·.¼TòKû¶º×/KÓŒ1EýhLØk'ážbYF¯’fæz0IýÕ]“0F$'/óúë¿Iƒdß§ Þ[`·ƒ¥?Y˜í-C#_dL××3ϱ”9À«?”ß(ù L•i:»P?uL1Æ^ŽÅŸvôFŽ]& ¿¯Ï{ž49ؾZƒë~\^I©LÆD?§r(¹—4ðÓŽÞHš±ë!ÀÔ®üo¤5Ýóò®-ÆDä3¸Ô1o‰ßï'gPFC% _¼’r}=+9†‘½qhN¡È±Ò4cLx¡wÆÄÔ¾] áR´«è»L¿¯Ï{!i¢ñ•¬$±ì`Y™&Œ mq3&ÎÀK w/“2z#iÆ®‡S»òÛÑL!1Áæ0öÓkC4ÁŒ›,ýÉ>ÈA_l{r}=óK~)mµLÅÀ‹Ú4Ó˜Þ­¯S¹ÐÖ˜l'üÓŽÞȱ±ë!Àôñûú¼çI“ƒŸJ%T#¨LÆî™_³ô€I~ÚÑI3v=˜Ú•ßÔçèŠQž¸{‰×G{Û붃¡­­ÜûÉÆ0ˆƒ½lߦeñÛ;¢oÄŠ»r•iv*§zwIEN3B ·¢]Fo䨨õ`zŒø}}Þó¤ñ­5“kR^öò˜*Ó„1Åôù!’ô¶r÷Ë2z#iÆ®‡S¯ò›ÁþH>ªlÚGòoÒ;qð (ûÏíÊo6pòå?Ä<-Tø`ZíùMÌä½k]6+ê˜*Ó„1ÙŸöaL±w*'ájä]Eo䨨õ`zŒø}}Þ+Ic[#þ®•Seš0&ƒÏ©\ N?&‰E»ˆ^'ÍÄõ `ŠíÊoûmUŒöG†MI¼_7ºLg7ìV~£1%%`Gò/S\¿Ùû°fŠZ,~µiƘ@~SèæØ¥hWÑ96v=˜âsÄï¸ÜóÛ§"“zWm,„ÉÊ4aL§»€_aí$ÍÝÈ»ŒÞHš±ë!ÀÔ©üÖ¨êÕê^“´y‰W|ø¢OéC¥¶+¿Õøª÷!ßÍ}˜ÖÛžà«zQj¡1U¦cz_uz3&N¹ ~z™Ñ96v=˜ž#~ÇUñ;E?õ²…=[¹Ê4^Í@søLI ‘Ú÷˜$^Šv½‘4c×C€©]ùí7p}Œ£ñ¼]))ç!ŠmV¶» Ø“ícòêʸPsþ/À´(~ç(èŒöY¼Ë#ÿ{ÀRš&Œ ÞŒéš1×Ê1þiGo䨨õ`zŽø—Ûždµ¥"ùÜš²»@e¯f¾RßU¹QSO˜Œw/“2z#iÆ®‡S»òÛv¶ïða){SRÂÿüØ:%/ßòf«µîûÉÑ@\r ü͹r××3ϱä#sEý ‰PQÇT™¦uLxŸübxì·rìR´«è»LÏ¿ãrå·¾y(©2MS–pŸÊEÅÐ[Íîrî2z#iÆ®‡S»ò;ú¨n´¢æÝaÄg¢ûÄÌ”vë˜ìÉ*Æ. Þp>jó_€iµòýîmÛÝky%¥2ÍSþÔÊcJ=V~•sWÑ96v=˜ž#~ÇUñ•mãnþ~˜SSiš0¦,ùžùeÀÔ£Ù~ÚÑ뤙¸žLЮü~MªñéMâ7ý7“¢@ôƒkÛê®Æôjz£¶ 4$§oŠß°(~gûÀ—–dûËbñ«L³iÏw3B—b§í‰}x?í軞LðñVÅïh4ÇO~ɽÊýaš0&Û|ܧrÑ^ÈÎQ.ÀO;z#iÆ®‡S»ò;8Û‰¶GÞl{’!g¿Ò’¢o7§¤Øv|ï‹öÓßÔ˜`YüÁǶ°†ÈE£¸Ê4aLkå”s»í‰QÅŸvôFŽ]¦çˆß°ÜóÛöH¤šˆ"å•i˜ÊGcÊ„½Õìnä]Fo$ÍØõ`jV~{¦Ww[Š·Å¥lìÕ X0ï‰ßï'£mKú³¿x‰÷úzæ9–4„ RØ6¨Åø¦Ê4cL!N~½„¤“cŸrî"z#ÇÆ®‡ÓsÄoX¿}ö¨R )([¹Ê4aLBŸî‚F:­umƒñÓŽÞHš±ë!ÀÔ¬ü¥€-ÌÒ{Œ)y7ÅL^ýCÞìÇäOfIôê5._ÝÊ­ŠßLhû$ÛܧŠI¼•i˜|ÎÒ͘òû·rìR´«è»LÏ¿aQüöf‚Á“™Š–µi˜l ½» Ä$¶'ù§½‘4c×C€©Yùm{)ÛjÄl`M4¯¿.aDÃa(´Í˜ÐGÊÇÌYÒ7ïÊÁrÛ“äs_’Oñ …ø]™&ŒÉ§bÝŒéåÔʱ»—I½‘cc×C€é9â7¬Šßb k ÿ60Œ©2M“½€÷‹(ï>€¤ÁKÑ®¢×I3q=˜°Yù ÙO¶5²Ïxá­+)ÿ÷?QŒ@”€èköÓcòΑ4£ÚÛöÅžß××3ϱ!útaä\hL•i˜lw{çØ'Û‘ ð*箢7rlìz0ásÄo\¿%s$±µG¥xY™&Œ‰)ÿ2¦a/E»ŠÞHš±ë!ÀÔ¬üá̶™Sû¯Í—œ¼ÂÒ~ÒB(nöcò'ÛÇ$íÄo– àrÏï¬Þê/³¼+XJÓlv!åÏ$!îÓÝÈ»ŒÞȱ±ë!Àôñ—{~Ûÿ Ú‚! åËÒ4eLòјÄVýNÒܼË褻LÍÊoûEÐ[1,”9ý˜”Œ(æôšL·É˜¼¡žÏòÍIa~˜–^ÿ³-)FæT\I©L³iÏ™>· Dr˜î)–eôFŽ]¦çˆß¸(~ûÒ“Ø^XÖ¦ c"ä{5s‰¤s å§½‘4c×C€©Yù ^z#q "›ý˜Ðg ‘ðÎ ´Í˜ü>ª7Ð8ïõ/À´(~g?"Œ†ÓäC%ÿ.~•i˜ߌ)è蘘~ÚÑ96v=˜ž#~ãjåw²ä׈!Šò_a²6M“­ÑŸ:&Æ^¹^åÜUôFÒŒ]¦få7°"û<¿„5¿ã_ôüN’bd}Ý]Þk{ò~²ølPb‰ñ›uL¸*~s6”$’ðî ðßS¹Ò4cL >uL†ý=¹àR´«è»LÏ¿qQü66jÿNä‡8%c*LÆú[ùÍØëùMá§½Nš‰ëÀDÍÊoxÕ}iJ„°;"<&Û‹ã<˜^¨FŒÉž,ÞW?Ûvú«uL´Üó[5 ¥¤«žß¥i¦1ÝÀôÚ³RG. »‘w½‘cc×3€‰ž#~ÓrÛL4ù­®PœÊU¦ cŠ)|4&bì¬ft÷2)£7’fìz05+¿ÙGPF²ÙTé©€)jôþ“®Smvð'çì |Xæ75&Z­üF¿»™)[\ŠËÊ4eLt÷üv`êåØUÎ]Eo䨨õ`zŽøM«â·½íœ’XÛzSR*Ó„1EÊ÷ï½?E'i.E»ŠÞHš±ë!ÀÔ®ü&’.|0m“·íÎ9æHÁˆSÞ®c²'çàÃ>@Søf¹­Šßìu¢Œ:¾G¢þiW˜fÓž£~úÊ3I1ñO;z#ÇÆ®‡ÓsÄoZ­ü6ëÕÅ1‡\ôc®M3Æô¾eôfL±w‰—®rî*z#iÆ®‡S»òm牶 ñi{Œ‰˜½x; )cÞÕ˜ìÉ^=å7xå«—xiµò;ùøNжZ±”såJÓtva¾Y¹·ìåØUÎ]Eo䨨õ`zŽøM«âwÌl/¾Ù±êÇT˜fŒ)ò½ÿ7`ênåòO;z#iÆ®‡S»òz[Üì;„½žßÿ÷?ïnÎbðκ˘üÉâ{~ûþ«À´*~KòfÁèÅðRœüV¦ÙìBäOå7ÅÔ©ü¦KÑ®¢7rlìz0=Gü¦eñÛ6 "{9`!~—¦ c ?•ß¶“ëT~ó­h—Ñ뤙¸žLÜ®üÆÀ Sl›ZÙdL Ðëj-Àf?¦×“5Šú "øæÀK^¿Å{ЍÈœŠ‹âµiƘø3‰¼Õ@'ÇâO;z#ÇÆ®g?GüæUñ;ƒÅ` ÖË”‹­\i¯f¶ûçOwŒ±³šñ¥hWÑI3v=˜Ú•ßÞõ<’gzbÞl­›%y£=ÉÙvd{—x¯'‹Q‹ŒÈóQ›ÿLËâ7ƒß´•%…Rü.MÆäêô͘|±ê䨭h—Ñ96v=˜ž#~órÛ“d6z& [¹Ê4^Í|(å]• H:â7ß½LÊ褻LíÊïè—iÕ¶·ÞFr·\ $”ÁõØwËN*5“?YŒ«§oXòråw`#މU€Ë‹â¥i˜ ¯?w倹Lw9w½‘cc×C€é9â7¯¼„,>O "WR*ÓŒ1ýÎüŠs1}¦XÑI3v=˜Ú•ß‘üÂ)åø¾Y`iïFD~å‘^“x—éýdqo™ Ú¾ LË/f¦üš²WXV¦Ù´g£I7c‚Ô»É÷Ë2z#ÇÆ®‡ÓsÄo^¿)PÒÈ¢>Vë/0U¦ cÊïbþp½Z½ýÿ¥hWÑI3v=˜Ú•ßNZCR? ¸y%Å ˜É‰ åu¤·Ã˜üÉQ‰É6‘óÀÿL«âwŽÑ+F3„ÿæXmšM{Ž¿³ £†ÎíÖŸvôFŽ]¦çˆß¼Úö$öƒß°*4¦Ê4aLéSùí-øÛI#W/“*z4×3€Iš•ßöç“÷~ ÄÁOµ÷“Ñ$Aá5ûIö“?‚‘&LÉþÇI–{~+Û+Ÿ‹¼þËÊKÓlv¡¦[Ç„4trìnä]Fo䨨õ `’çˆß²*~söSm `I\\°¬L3Æ>U¹1j¯»€\Šv½‘4c×C€©Yùí3” rŽLQ·Äï×…>Ç×oÓ0]OF¿,Oô›[9Y¿½ŸHŸWs¡1U¦Ù´çô©•Cî+—KÑ®¢7rlìz0=Gü–å¶'Á¼r´ÿ,ú1צ còÙ\7cŠÝ¶'r÷2)£7’fìz05+¿½„(ͳE~~Ç¿`Lâå:¬>çŒâ6cr„âúÂõá¦Uñ[HD|y±Õ¥,(M3Æ$ð©ü¶}WGÇ”KÑ®¢7rlìz0=Gü–Uñ[íû%ûB,‡Sq%¥2MS‚ëJŠ3&’Þjv)ÚUôFÒŒ]¦få·-»¶'ðánL¼­1ÙN\)ùQ¥½­ÜûÉ’‘#æ¬ñ›wådyà¥mM˜”Cqí©6ͦ=¿ wß³ Swñ»§X–Ñ96v=˜ž#~˪øØV>Ÿ*í3=Šýiš1&Ÿ~LQB˜òO;z#iÆ®‡S³òÛiÃQÛË!úÞ`·í‰m…(ÚGšò&cò''Ûÿ‹W¼~˜–+¿m7‹ÞcØ~³PSašM{òaåÚmß,w9w½‘cc×C€é9â·,÷üö1ÉÞ…\¶Ö-MÆ$æüaLQ;G¹énä]F¯“fâz0¥fåwLÑÁÖtÁusø„ ¨Ù£ï2&rô<(”¿YÇ”V+¿}îÍ©¼ä´ìÇTšfÓžÃçT.jÀcJW9w½‘cc×3€)=GüN‹â·Ÿt¡½ñ#—ã›+Ó„1‰¦ûwôºÂÎj–à§½‘4c×C€©YùS0Î%ÍþÉï1&åÈN:)cDÞdLþäW1æ…B…¦eñ;D NEHSÙó«4ͦ=“üN{†^ϯt+ÚeôFŽ]¦çˆßiYüö¾µö" K9ð²2M'þhLÁxB'inE»ŒÞHš±ë!ÀÔ¬üޝI~+º@¶Ç˜lÇjûD)AÞÚʽŸì•ÙxÈ7;X¦Uñì}‡àíº USR Ó”1¥O­œè1¦KÑ®¢7rlìz0=GüNË/Sò«¦l«TX–¦ cb÷‰‰÷ÛêÔ˜¤{Še½‘4c×C€©YùmÛ)—¿!ù ¥¸©1ù¸YÛS€ÑÄ”a÷TΞl?Ê9Ðov°L«â7æ”\XÎÕ]¹Ò4›](¿=¿rNeºí*z#ÇÆ®‡ÓsÄï´ÜóýôG-5•—xKÓLc ¿Ý÷&ñ¦»‘w½‘4c×C€©YùmêWiÅ~í@»wå JÌ™(îÞ•ó'G”ü\oÞ ê_€iUüöUÛ”Úh*ZëV¦ c⨟ž_)P§ˆ7]Šv½‘cc×C€é9âwZ¿_÷,‘ÿÝÿצ™Æòé.RïJJ?íèuÒL\Ϧܮü6@1¾¢,e>¨»`L1ŠOÀŸµ¾É˜|ÎUöZ"¤oS^îùTý®cŽ…ÆT™f“xH?ŒI˜;:f¾y—Ñ96v=˜òsÄï¼*~«øõ¯{%(î1U¦™ÆôŸI¼r/ià§½‘4c×C€©]ù>ØÕvrÂ~@¶É˜8a6P ‘˜·5&‡Ä„˜8Û;öÍ˼*~sö —9…¢Q\ešÍ.ÔÏ””èÕZ»í*z#ÇÆ®‡ÓsÄï¼*~sð¡ê—ÑŠFñµi¦1!ß½r¢k¾¤¹í*z#iÆ®‡S»ò}Ä S ¶Ãf?&JRά!¾j$·S°U_øeÿ˜VÅïäH‹9d¿<ø˜*ÓŒ1Eý°rÁ^¹@¾í*z#ÇÆ®‡ÓsÄï¼*~3*åD1mOkÓŒ1½oùj¦þÏïãþ$Í¥hWÑI3v=˜Ú•ßÀ~a)³Ä–øýLYSdax7sÚaLàµË^É&âE?_¦õžß4§LŠÅˆðÚ4aL(ô™ÄÃÚÓ˜ò§‘w½‘cc×C€é9âw^¿Å;± FðÛB©2ÍÓ{2ªÿŽê×n;Àt)ÚUôFÒŒ]¦vå··à ѯ6§­r —“@ˆ_Ãv“ËR"`/š-ßl­›WÅo×áý˜P eK`*MÆ„g2tNåò¥hWÑ96v=˜ž#~çUñ‘Í9ù ³¿ÀT™&ŒÉöÿ·Æ¤>~¨ Lz)ÚUô:i&®g“¶+¿#&û7#Øt>v²Ô˜‚í5úÈÊŒ»“÷[G•`¿|uD¸®ŠßÊŒ ć B5†¾0M§=ÿNâ1"ÝјôR´«è»žLúñ[WÅï”ÑïeåŒ!,+Ó„1ñ½š)é{ÌN#i.E»ŠÞHš±ë!ÀÔ®üŽ€ÙÒ=çÚº’âJŠ/Û¶­° ì»gÊc²ýz×3ȶ'ü&0-Šß~±†²·a£$+¯L3ÆÄùS+gü¦£1é[Ñ®£7rlìz0=GüÖUñ[Ñ Ùg#rÑ]°6MâGcz‚ëÓ¥hWÑI3v=˜Ú•ßA‚úL oضÊ\IaoÖÉ9ø¹Ü.cò»0Љ ÖÂüúð¿Ózå·ŸØz+ÏÅV®2Í4&ûH>Œ‰zCUõSÎ]Do䨨õ`zŽø­‹âw²uÕ6 Éûcå²\ 4M“­7÷j¦ñ}ݶLòÓŽÞHš±ë!ÀÔ¬üVoˆèDƒ‘ظîïA'ÉUµ@’øÕ„rƒ1Ù“Sȶ‹Ë\.™üð¿ÓªøÅþ É>)•ß•i˜€ùSÇÄ>I´ L—¢]Eo䨨õ`zŽø­«â·Woøx¤  š]™fŒ)Ê}ó;Ûf"t€éR´«è¤»LÍÊo% ̯N­aã`í]ùÍ~} qk?Ù'7ˆaR¥é“ÿ˜–+¿Å8` j”·(I©M3)ÂçT΋µ;Àt—s—Ñ96v=˜ž#~ëªø¼~Ѧ WŠ))•iƘü%zÿŽYø}Ù²Jš.E»Š^%ÍÌõ`JõWçŒÉ6pý®zöÖÔ{Œ)x3$û@ ×¶†¼ž½OŸ:çú0]_Ï<Çì¥'H¶‰ŠÛµi6í9üÞ•£Hí"^£Ö?íè»L)ïyÒ¡€JâgjEÏïÊ4cLïýö×±LW#ï*z#iÆ®‡S³ò;)ù!¥ËØù=¨{ƒ1ÅëÑ—èt«\àõd,gÛ9ð[-ߦÕÊoû|Ìm,Ç7•¦é´ç_ µ¯=¥p•sWÑ96v=˜#~_Ÿ÷8öÉ€\Ö1•¦Ù´gúÔÊùÝ›ÞVîR´«è»L¿¯Ï{ž4Ù‡ Ù¾áu‡ñïhÚ4cLá3W>»¶Ò¦KÑ®¢7’fìz05+¿ýÆ•ë±TÇ„[Àô.B¿l§qOüö'ƒ \Æ/Õ0júÃÿL«â7ª1øÀÞª¿+ÓŒ1IÔcŠ]Æt)ÚUôFŽ]¦Çˆß×ç=Oo³È]¾©Nå*Ód5ƒ÷aþ‹1Q|]°lS¼í*z4×3€)6+¿²w‘dïêhC&z1&¿yÁ~²¦º ŒÉ¨Vô1¼^{ŽÓÀÿLq}à¥íhý¾cRÜ.¨L3Æ¿ŒÉ¸=¾)ÅÏË"z#ÇÆ®gS|ŽøWÅoÿ2”¼{},FëÔ¦Éjæí’nÆbèÓ¥hWÑI3v=˜š•ßÞ²Äö¶¢†›§rêgš~o ½w·kLlh2&ˆ^ ™²fð"æ/ÓrÏoD”|zo¹•+LSÆt‰ßΘ‚ö€énä]Fo䨨õ`zŽøWÅod2⯶¬K.Ê*Ód5‹ïq:¾š%al_âMñR´«è¤»LÍÊoñKþ@lJÜ>•ó͘C 2Á‹1-ÓëÉàedèçLù›[¹¸*~ÛÂ"Y’ï,Ë»r•iƘ˜>wå°×ÁÒãO;z#ÇÆ®‡ÓsÄï¸Üó[½Ó!”[¹Ê4YÍâ}ÁÒ^-Û«÷ÓÝÈ»ŒÞHš±ë!ÀÔ¬üfgwÞ$65&24Rˆ¶~Û~îuŸeƒ1±_”· ÅoRSüŽË/ÁkÙ1zydQÇT™&9–9~`¯Ž)ÞS,Ëè»LÏ¿ãªøM) åWCí²Ž©2M“ÞU¹IºuL1ÿ´£7’fìz05+¿™Ib¤L(ÞêvScbää¥[¯q1Ù“)ºtž}ñÿfS\¿}~U¦è—c(O~KÓ$Çrà_)t:XIýiGo䨨õ`zŽø—^[Ö½çG.€©2Í¥c"é4г·ô§½Nš‰ëÀÍÊo/ü–œ•³LÚ&ƒuÃ5Û ûiä«lœ6“gÚ‡'~Ch^¨ðÀ«•ß¶Cò#ÛCÔBcªL³iÏùÓÁÂzn_âMp•sWÑ96v=˜à9â7¬Šß¶Lø]SPÛ4,+ÓŒ1½‹ù_Œ‰¸Ó(.Á¥hWÑI3v=˜š•ßl p M B»WRÄ5ºÌŽ-úRÎwSbï'ß›„/Þ•»¾žyŽ¥,QrJìSešäXzo´ÞÓž±3ð2þ´£7rlìz0=Gü†Eñ;iòF€Þ=Hq] 2MS¾çÊc’N%ÐO;z#iÆ®‡S³òÛ[½EÍ@^Ž4/sü›4~ù&dŒ,â§s›“¯ú¾1É߬ü†Uñ[e!ƒI¯ë*Saš1&ŠŸ¾ò±7",ÿ´£7rlìz0=Gü†Uñ[í›–× XXV¦c²ä͘lÍ`ºí*z#iÆ®‡S³òÛÈ#gŸÞ$·îá:cL (%µÝÊV¹ÀëÉF05cây—¹¦åžß^T.Åg*®¤T¦ÙìB‰w­œåõ€énä]Fo䨨õ`zŽø ËâwdöKð *E¹@eš1&¸’ƼS§S‚[Ñ.£7’fìz05+¿}¦[Hj(aHÜdLéÕ/…C¶ÿÖ=ñûõdˆ‰*ÉyÀ7iµò[íOñ®y,PV~W¦ÙìBÃù›1…÷â×&ýiGo䨨õ`zŽø Ë=¿‰U%x¿-ë˜JÓd5 ú[Çdÿ»ÓöïFÞeô:i&®g6+¿Éè¯%ÛYmÕ1ýßÿ2dû(Q Žm3¸©1Ù“ –ж¿ jÎÿ˜pYüö[”“HHE3ÂÊ4cLø7c Ú­uÞŠv½‘cc×3€ Ÿ#~ãªø ‰Ú빦Ê4YÍ 6îÕLT;­u-ÞO;z#iÆ®‡S³ò›ÄRœl;‡Œa~1äoÒØfÂ?Ú›'¼YùmOö†ëÉ7tüÕr\x ’üŒRè¯\P›æÓžg¦Ü¦{Še½‘cc×C€é9â7®V~ÛËÄ#Q*kLJÓŒ1 ß«™h€ŽÆ„W9w½‘4c×C€©YùÍ!0åàÕzÆõ¶€Éø¦ß”,mwA¼}*G€^béÃV¾¹•ÃUñÛöáèãõ쳨€©4ÍSüÔÊùôÓN¹^Šv½‘cc×C€é9â7.W~[î«ß«¶µ¢Ô˜JÓŒ1¡ÜuL’â{[×Hš»œ»ŒÞHš±ë!ÀÔ®üö.möëÆDAw[ëß ¶v!H*¯Ñp;§r>.3»Ê”|¤Ý7iYüà£;Õo*'ñ”¦ÙìÂ>ý˜B·\oE»ŒÞȱ±ë!Àôñ—Ûžø\dƜ˗•iƘ Ý÷˜ @B§í Þ½LÊ褻LíÊï-Í-Ù%Á&c’(~h 9îÖ1ù¬L–`;_{ü7 ,qYüöÛ1”übq(KRJÓlÚóûŠí›1!÷Ó­h—Ñ96v=˜ž#~ã²øýÚÙzá]K ñ»4W3õ«#×´ {±R‡1Ñ­h—Ñ뤙¸žLÔ¬üû•Á{taœ+=Eû{IìeØ<•³'ƒæ×vÎgŠ|˜h¹íI$6z#)¤ò¢xeš3¦û=0`JK¼t÷2)£7rlìz0ÑsÄoZ¿ÉöÖ9qˆ¥h{R™Æ«™Ú‹”_ÀäoGì‰ßt)ÚUôFÒŒ]¦få·Ñ;ï‰ÀàÃötw|SN„.b!l]â}=ÙÛÀk~ãW;XÒªø->JÊXœ1@ú»øÕ¦9cºg0õ.ñþ´£7rlìz0=Gü¦åÊïl›|]ˆŒEñ[eš0&¤œnÆd«Y{o¢»œ»ŒÞHš±ë!ÀÔ¬ü–¬¶¥2@ „^¿ÙZ—TÙpåu°·%~¿ž,ÁE܈BøÍ¶'´(~2S| áD)æÊÕ¦c’ô{*‡½¶'Ä?íè»LÏ¿iUüŽY£&°u¥¸+W™Æ«Yö>[cb~Kˆ-`ºí*z#iÆ®‡S³ò;Ù'À>IIKÜÔ˜¼;…ˆ¼ËÜÖ•”דmHöÒªÏJû&0­Šßö®Û›ïen‚ekÝÒ4=•£Ï]9ï Ó¦KÑ®¢7rlìz0=Gü¦Uñ;eoþẒR™Æ«Y&‚|1&¶7«S`I—¢]Eo$ÍØõ`jV~{GÝÀ¾ u½h³ŽÉ“eê¼Üo‹19Û  —BˆóË0ÿLËâ7ú¿]¿!­†¦c‚pß.ˆ!ôz~Ó­h—Ñ96v=˜ž#~ÓªøÍÙ›-&±£FP™&ŒÉÛrߌÉÛè·‰/E»Š^'ÍÄõ `âfå·aiŽÁo: íƶ¶r>›¼9^HÎ^¥H;Œ)ƒmäs6²Åè‹ÀÄË•ßâ—þ¼“¤˜*Ó„1‘^#Â^‡-½kO|—s—Ñ96v=˜ø9â7/÷ü‘ýv­íå$ÞÊ4aLoÆJS9¾y—ÑI3v=˜š•ßÙg|‰§F™6û1ϬL>DSÞk{âOß>fQ >"í‹À´<ðÒ¾:ïŒ ‘ËK¼•i˜l—zw°Tc8"^¾§X–Ñ96v=˜ž#~ójå7»BжG‚\#¨LÆd½OåØ8w˜®rî*z#iÆ®‡S³ò;ƒ·áè—hdo+÷ÿCÌÑÙ¡áŠoÈö“=Ù[ÌiöŽ¢ôUÆ´ÜöÄP2Dûë:¦Ê4cL€w EáN­ß½LÊè»LÏ¿yUüæè—E|DD¹•+MãṎÉ͘B†Î©_Šv½‘4c×C€©Yù‘È[ûøu5J[mOÂÿí¥'VŸ'´YÇdO6Ò7 ,y¹ò›å¹ºÄ[™f³ ³|SŒÒ˱»œ»ŒÞȱ±ë!Àôñ›—+¿Q(ŽHÙZ·2W³äC¼/Æä×H{ûÿ»œ»ŒÞHš±ë!ÀÔ¬üÎöÿw¶ƒ îžÊ¨½nmù¹“ku{ŒÉ¾{Ã¥W?bž'ÿ`Z¿}`›ß üîqúßá¥i6í9ã]ù­!k1]Šv½‘cc×C€é9â7/÷üN”‰\ú³Õù/0U¦ cò†°c"…Ü™’"w#ï2z4×3€Iš•ß™Ùk‰Ùà!§ù¡}Á˜|+G‘üZ‹OÙcLLJm3g»9ý&c’eñÛ Ä`²·¿Ð1kÓ|Ú3^ïctXäV´Ë軞Lòñ[VÅï×k²÷߇¯ÿ-~+MÆ$9æc‚Üéù-—¢]Eo$ÍØõ`jV~û”K—+ŒìíjL>NÀ×ðˆ2lžÊeï…¥>.~µŽI–ÅoM9{¿IÛ“uL•i6í9}4¦Œ,SnE»ŒÞȱ±ë!Àôñ[VÅoÂX|mÎõ•”Â4cL!ßwå¼Ä:IC?í褻LÍÊo§I‘Ь¶ÝFà˜Œð wî6TË[Àôz2pN9Äd¸öU`Zn{"1«7Ôòa·©2ͦ=#Þ,²poñ»{™”Ñ96v=˜ž#~˪ø¶¶ÛjáMØ©¨ü®LÆd»—»òÛö©—4—¢]Eo$ÍØõ`jV~¿F]r"dû¿ùUÚ²»€ú©Z Ù¬üöIW`@ÎÈFœ¾y‰W–^Úží¥Wâ\v°,M3Æôîóýê’ê÷:9vO±,£7rlìz0=Gü–Uñ[Ô5¶¶¦Ê4aL¯¡/ÆäW2:Is)ÚUôFÒŒ]¦få·ÿ‰wóØ.D 4¢€ò»î{ŒÉk¾Ñ똽ÞૌiUüFEûþ‚†S!~W¦Y_yÁ»KªÏíÔ1É¥hWÑ96v=˜ž#~ËrÛ“dßHV®º T¦c’×!Л1Q¯Sº{™”Ñ뤙¸žL©YùQ0ØfÎvtü.EÚaLöÓÑ+¡²ßjÙ­c²ŸM¾ñúÌ/SZm{‚úÙ*f(r¬2Í&ñ€Ü=¿ìäÎKºz™TÑ96v=˜ÒsÄï´*~ûLäÄÉûФð7i*Ó„1ùw{3&Þut)ÚUôFÒŒ]¦vå·Ñ³ -%zÀô™bYDo䨨õ`zŽøÅï¤Ålö«ÅQneš1¦LÉq/iòO;z#iÆ®‡S³ò[1RdÛÏiô) ›ŒI]eâ AÔv{ŒIhù=½àÂûW·r‹â·W{RVµ£lWšfŒ)¿ÜÞŒ)¤žŽ©?íè»LϿӪøMª~y1“½…ÆT™Æ«™°|º P̽îùR´«èuÒL\ϦܬüV!/½rÅ'ov°Ìö~ä×m;à˜·¶r¯'g€Õ@JÓóÀ¦¼ZùmÐÃëâ~*Ë*ÓLc ŸI¼icW9w½‘cc×3€)?Gü΋â·T¤ ʹrµi¼šy‰3ÜŒé*…l% ü´£7’fìz05+¿(Q¤m3æçê»så|¸Š$z-㛓=ì©cþªøWÅï$ `¶]&–—xKÓŒ1…tÏ•³…°w3_Šv½‘cc×C€é9âw^îùÀUÄ…BÙó»4MSNéî.àµÚ“|7ò.£7’fìz05+¿¯øMx1ÂawJJJŒ†i”‘îöcRr®æM¬`å<ð_€iUüö‚èMkí7ûËÊkÓLcúí`i?Cr|)ÚUôFŽ]¦çˆßyyà%%7ً˶'•i˜˜ôÓ] Jï®\¾§X–ÑI3v=˜š•ßjû(£L@‘5ï7Æäª­Þ^ü {Ã^OfĬ¯~qñ«[¹åÊoûS¼>(V•ߥiʘògÚó«™z;Çîrî2z#ÇÆ®‡ÓsÄï¼ZùÍ$«º¨‘ÿ2¦Ú4aL¤ô©cŠ®ø¶“&ÿ´£7’fìz05+¿½%ª­Á‰ œ6OåD3ù­0sÁw5ýc‚„É»@ÙÿŠß<•Ë«•ß>«”„*—=¿+ÓdOÊ¿“xlƒßÛÊ]åÜUôFŽ]¦çˆßy¹ç7xý‘AŠ2–ÀTš&ŒÉB¸“—ßµ“FïFÞeô:i&®g“6+¿‘2‚×2m3&o.àåjÛ§r^TšÁÞ5ýfk]]xÈ©ŸmÅ–E¼¥i2»Ðh9Þ³ !õZëê=ŲŒÞȱ±ëÀ¤Ï¿uyàeôîk¶Û°Õ½¸+W™&Œ Þ=dý3³ˆ=`º§X–ÑI3v=˜š•ߊ¢-®b«Ðæ]¹É~Èè’FÈy³“ë$>/Ó¶sYÒÿ˜VÅïLšÈvá"¡˜+W›&ŒI8Ü÷1-ßz­uõR´«è»LÏ¿u¹í‰mºŒñcòö6%0¦ cŠ ÷©œk­œÞ½LÊ褻LÍÊobÒ b [Àd/ˆ¾ ôqº(›“xíÉ> …|w’æóYþ˜VÅoò›öKÙ^<=¿+Ó„1±@ø0 ãŸvôFŽ]¦çˆßº,~sPÛ{©SR*Ó„1Å÷³c²o··šÝŠv½‘4c×C€©Yù­~&†B¯ªSÙÔ˜HÔ~&åbÜì.`Oçk1HüÍ–º,~Ë«3•mLËa¥i˜ Å{v¡}B½+)z+ÚeôFŽ]¦çˆßº*~ƒ½:l[%Ê”ŠS¹Ê4aLÁ§ïÞŒ©ÛöT/E»ŠÞHš±ë!ÀÔ®üöNå H£ÿ÷æ\¹×´êÀÙʰm·ŽÉ¨RT/°”¿Y. «âw²M’ûmŒôå•i˜Œ~~fª1éNŽéO;z#ÇÆ®‡ÓsÄo]¿£äd{$o*–Êa¥i¼š±½Jx3¦DñM9\Šv½Jš™ëÀ”ë¯îŘlÿæâ³a©mÌ6^Fo.Þz(Æ8 ¥ÊoÕÌ’X[*¾L××3ϱ¤‘’Ç ®.ÿ¦Ê4aL1áÍÊ}†L˜r¸Ê¹«è»L9ïyÒde¶qÈÑ 8•+MãÕŒ%}:Xú ÞvI—¢]Eo$ÍØõ`jV~û ¹í7÷"Kºg4,&AØfXÀËí1&/¬ÌAÀ@ â§~£ûÃÿLË=¿ˆ$²-mzOü¯ÆTš&Œ)$üÌ.Ì©Óó+‡»‘w½‘cc×C€é1â÷õyÏ“&¿Z™ù5!‰XŠß¥i˜$Ãý0¥öV.‡[Ñ.£7’fìz05+¿}/òëf¨à0Ù'i´ ûQû³ãkžÀ†ÆäW[]À ÂÆoÓ²ø À5©Ñ¸˜JÓdÚsúÕ˜^]à;9v+ÚeôFŽ]¦Çˆß×ç=O?ƒçL>ƒ«¶'¥i˜ló 7cº ¤•4w/“2z#iÆ®‡S³ò;Fd޶‹ËœX7SŽèC>ÙÏ9mßdLöƒ@¤ïɲÓ'ÿ 0-·=ñié¶·ÿ(4¦Ò4™öÌAoVÎö7¶ë˜r¸{™”Ñ96v=˜#~_Ÿ÷BÒd~Õ»ÅÊ%Í®L3Æúј˜µÝ)‡«—I½‘4c×C€©YùmD‡½°rFžÃÃ_Ƥ‰‚_⟠óšn¼Ã˜ìÉŒ!úÍÅé›À´Üö„‚ÈëJq,îcÖ¦ c从‰9q»\ ‡»—I½‘cc×C€é1â÷õyÏ“ÆÞv’ ~«‹sYüVš&ŒÉÞ…Ï©œ­<íë9†Ÿvô:i&®gSlV~WÉ^£]ÂïäôŤ‰Ñ¸’× Ûî˜çS¾ ÆdO‘QÙÓ¿ LqUü~ÍD"Š˜b1»°6M5&ÁÆÄÒ¿ã¥hWÑ96v=˜âsÄï¸\ùÚPy‰·4MSü©cŠÒéÇœã]Î]Fo$ÍØõ`jV~ûNζŸ¤Æ^Àcò±ŽèŒÑ§l´&ÀëÉÞtÆÖƒòonåâ¢øm„_ýo^[ôü®M3Æ”cü0&í.~øÓŽÞȱ±ë!Àôñ;®Šß¢hé+–ÆX´¤¨MãÕŒ2|&ñYÀŽø/E»ŠÞHš±ë!ÀÔ¬üލ>ÿÓPÉ )N%è‚1ùõ_ìåÛ6æ‹¿“mm;"¢Þpî›À´(~íó¾íÞí ¤¿[¹Ú4Ó˜ˆ>‡NkÝߊv½‘cc×C€é9âw\¿ýš×ÊIX^â-M3Æ„øË˜¼P;i.E»ŠÞHš±ë!ÀÔ¬üŽ>ÖÜöSÁ{ܦ)<Œ‰„¢ÏX‰‰U¶“JgHáó…tø_€iUüVõaRC|‘ü·Ž©4MúÊkÔ»‚ãŸÇýɱKÑ®¢7rlìz0=GüŽ«âw"—1¼È8bÑó»2M“Þ=¿1ìˆßñR´«è¤»LÍÊïH~fÏÞc€I·Êì‡}?Ñ/»eÖx=Y¢÷‰ ˜ð«ÓrÛ•ý cþ{í©6M„O­tÌ»—I½‘cc×C€é9âw\¿Ú SJ±­S™Æ«™_ïºß@°×²C³áR´«èuÒL\Ï&hV~Gñ«nYýÀWcb» b8oÌ~Â÷“Y!i´ÿþæV–+¿òÚ·‡¶\AL•i¢1èý'1tNåà.ç.£7rlìz0ÁsÄoX®üö›UÞ\:ÅPÔ1U¦ c†{®H’ÎjðÓŽÞHš±ë!ÀÔ®üOòטnÝ&—‰RJÁ•sÍ1î2&{rðúV¯Þ oXÂrÏï”0“ÁJ!Ô¦cÒpç#hçvܼËè»LÏ¿auà¥m"ò«îµ­S›&ŒÉúc²MWçº\S,«è¤»LíÊo1Γ½Iq¯ÀÒ‹·E’ë%Œi>å»dLI)£ Wů2¦ÕÊo§´1*'¿µi¢1eˬ›1ȹ®rî*z#ÇÆ®‡ÓsÄoXn{’BV†XŽÖ©MÆdØqïÿ½»k§Æî^&eôFÒŒ]¦vå·øœЛ.N•ž¢µ®Dñ8¶¥ 6+¿íÉôšã›‰â7Ë`QüÎÑþŠÉ蟤¢aešÌ.¤÷W—ÔWI};ÇÒO;z#ÇÆ®‡ÓsÄoXm{bé…ö¡_ü(.ñV¦cÊù—1a§íI†«—I½‘4c×C€©]ù‚sŸm¾U`i°®Þ-Ü—FØìÇäO¶5Ÿ|¹ÀVÅoñë5dL$H9‰§2ͦ=§Oi‰tå‚KÑ®¢7rlìz0=Gü†õ¶'ǘX´(°¬L3)ª~4¦÷¦«‘4øéeRD¯“fâz0a»òÛèRNÞFÒ6V»WR ŒìÏe×°hëïûɶ‹Ù/Ìãÿ˜pUüN¯*!ˆ¬Xü–¦ cò6S7c2,é^Šv½‘cc×3€ Ÿ#~ãªø ½ÉtLeUneš0¦ øaLܦKÑ®¢7’fìz0µ+¿“oÃ̘¼óæf¹€CG"MÊ7{~Û“I‘¼­^äôÍ:&\xIÞ,}Ä^q‰·0M“mqï“8kGÇÄÏË"z#ÇÆ®‡ÓsÄo\­ü¶uÉ¢,’йò•i¼š¡ÂçØrÖÙÿãUÎ]Eo$ÍØõ`jW~'ÂDAsÞl{¢®ya$”íîödT[ù%PÂéyà¿Óªøô5¾3¨rQù]›&]R½‰Ì͘ü´¥“c—¢]Eo䨨õ`zŽøË•ßö]û— •âJÓŒ1ñçtµG³ïrî2z#iÆ®‡S»ò[ü\2G DÞx¯\$F‚ôêø½w‰÷ýäÃ뮜†ojL¸ZùmT:Eˆ~3 •ß•i6»0°–"usì*箢7rlìz0=GüÆUñÛKË8¿xcªLÉ·/)vÆ7g¼í*z#iÆ®‡S»ò[üÐ%gÜ;•óK{é•P®—[uL„ht†‚}b_ÝÊ-W~@V*9”WR*Ó„1ù “ûvÁkÄq;Çîrî2z#ÇÆ®‡ÓsÄo\¿B€‚ñØraeš1&úeLÐ9•£KÑ®¢×I3q=˜¨SùÍ@j[PPû½wÛždoYQ|rõ.cbûIII½­Sþ"0ѪøÍ¶=ráËÞþòvAešõ•W¼Y9úÊNŽ]Šv½‘cc×3€‰ž#~Ó†ø­.“r–XSeš1&Ô{5ι—4¿Šöß褻LíÊï^Pä²XN´y‰¢áºw˜ó#ìù¦Jcò/"òvÓMä¿ÓjÛÛä'ETÉRµo.M“ž_ŠŸI¼˜4tXèêeREo䨨õ`zŽøM«âwЉ¢7¾/šxÕ¦ñj†YOå{­uéR´«è¤»LíÊïœB ¿â`з€Éù¦‘% jÀæåÍ›Œ)‹½]hÛ_b ß,°¤EñÛ0Òk«€‰ŠËÊ4›]˜â­1¡bîœÊÿ´£7rlìz0=Gü¦UñÛ^ug"þp1ð²2MNåDÃ=‰ÐG9µ“æR´«è¤»LíÊoÛÆIŒqº¡*“½óÉû•b »ŒÉž ÞM4(@üæ©-·= b›Jö’̪íIišiL>õíÖ˜RîåØÝˤŒÞȱ±ë!Àôñ›VÅï׬XÛ+%HEÒÔ¦ câßÛª¡w]€òO;z#iÆ®‡S»ò[çتÃtˆÒߤÁ׸K/’ŒpWcRïÆH†áöõ/­Šßôº´ïeY¹š’RšfŒI˜SèÓ¥hWÑ96v=˜ž#~ÓªøÍb넽Ùþ¯¨ü®LÆÄ>•ßzWR8ü´£×I3q=˜¸]ùmoMÊöG¤D8/sü˘0Šúh oºµÅ˜0±LôN1é›såxQüÎÁ# {›¨¢¯|mšiLÞ‘ûÖ˜D::&ÇŸvôFŽ]Ï&~ŽøÍ«â7"§BÄX^I©LÆDQn1¢Ëí¤¹í*z#iÆ®‡S»ò[Å0ÉGŸIÊ{â·A¼qCÛ fv,ÞeLƲPƒá¹·ÿ&0­V~Û×æ×Š^E²ÅV®2ÍNå(ÿN{Ω#~óUÎ]Eo䨨õ`zŽøÍË=¿ÑolG¯P.GëT¦ cB‰ŸS9ÛÇtZRðÝÈ»ŒÞHš±ë!ÀÔ®üΙX½fIæJOÁ˜c|MF°1_¯'ûÉ»üþM`Z­üÎJ~ºèm¢ä¯ø]›¦³ çŽÉ(ag+ÇW9w½‘cc×C€é9â7¯÷ü™|*GªÅ¦ cŸS¹ÀÒ¦O#ï"z#iÆ®‡S»òÛh’_òÇŒûl‰ßñ`DÉï¼á»}Ìæ©ù m?Ù ¶Ùù&0­Šßä}ÏEÙN*SešÍ.ŒŸ¦œÈÒ»Éé§½‘cc×C€é9â7¯Šß˜ØÛK^‹­\iš1¦ÈŸS¹ ½))|)ÚUôFÒŒ]¦vå·màÀÞÛ{p ]É÷b)gçw+¿S¶MNŽäÚ{þf¹¯Šß1¡a40d¿¼÷˜*Ó„1êGc2ŠÓÓ˜.E»ŠÞȱ±ë!Àôñ›—Åï८è=/¡¿KÓŒ1ñgÏ^IÕN¹í2z4×3€I:•ßÞÞ.E‘Íá.§Ùf8ƒÊnåûÉ(Ù¶<É6Áß,å—lD„PŽÅV®2MSd½é§ÑÉ0É=ŲŒÞȱ±ëÀ$Ï¿eQü~A2.rÝ<ús©0ÍSΟS¹¤#~ ü´£7’fìz0uz~'âlÒ¶ei÷®œýmZ“í5rØÕ˜ìɘÙß°üÍ+)²Üöäuq?Iô!$s¬2ͦ=Ó/c‚w¯ÉVŽÝ½LÊè»LÏ¿eUüŽœ}2bJ‘b¡1U¦ c‚û(×Ϭ•{«Ù¥hWÑI3v=˜z=¿S€(žìy~Ç¿¸+§,†ì$¯½ÅÖ0‚ד…l3m#©_Ä+Ëâ·¡k@õºQ)ÇЗ¦)cúè˜L½ÅïV´Ëè»LÏ¿e¹ç7xáK,hvmš0¦óÝ]À§ö’ænä]Fo$ÍØõ`êôüeËô˜_ÇW»Ý$&½àí/y{JŠäì¯üÊsüfwY¿1£fG%Æ"‹­\iš0¦ ×¨<_¡Wù-—¢]Eo䨨õ`zŽø-Ë/}ø˜­ì˜–såJÓ„1…ßÚ€)wzåÈ=ŲŒÞHš±ë!ÀÔ®üµwH}F FØ<•‹^›½bÀk%·¶rï'ƒøD»`[¯jL«â7ÚÎ2`–Ëiϵi6íYé—1AW.¸í*z#ÇÆ®‡ÓsÄoY¿Ñ–U ö…g-G„W¦ñj/èbLÆŒ;G¹éR´«èuÒL\ϦԮüÆœÀ;"„´;ðÒ5X/üNÞ€ ·†¼Ÿì×`¼”ð7+¿ÓrÛsMšÁ‹ËËÒ4›ölüùfL1öN~ÓÝˤŒÞȱ±ëÀ”ž#~§å¶'¶a€Ä'Þwå*Óx5Å|_ÍòV%Æ”î^&eôFÒŒ]¦vå·°ñ$½Åýnw1`· {m ìöü¯l›9ïÎûM`Z¿Á»¤@©ìùU›&=¿òo„Ï3ét°H·¢]Fo䨨õ`zŽøVÅoð{‘Y’†PSiš0¦ÌüaLIz-)Ò¥hWÑI3v=˜Ú•ß"¯“çý_›­u“ ×ɶr~QöL´¥1œ%ÃD¿y‰7­Šßdߟ÷úÏeÏïÊ4aLI騆^Ž]Šv½‘cc×C€é9âwZ¿Ù…Rõ½R5ð²4M“ŸžÝŒéZwZIs+ÚeôFÒŒ]¦NÏooI•r”—T´·•óŠqñi—Þéüuw‹1Ùî/ûaŸÇ÷Õ­ÜêÀKûâ²}$–E¼¥i˜ä·Å(ôZë¤kŠe½‘cc×C€é9âwZ®üf´ôͶQÊR^â-MÆ$9ÜÝáô4¦»œ»ŒÞHš±ë!ÀÔéùDbð…4n¶=ÉÀ·’¼«1%N¶øG/  _eL«â7 ñN.@$cªL3ÆásS÷4¦KÑ®¢7rlìz0=GüN«â··3{âsÙ(¾6M“ü¾Þm²³šåKÑ®¢×I3q=˜r§ò;¤—øRˆó UQ.`ïI ü„!†ížßÁ6½êêV‚ôÍ˼*~;µR0œ.{~W¦ câß#NÈ”:S¾í*z#ÇÆ®gS~ŽøWÅo¿¹ àý“S±šÕ¦ cbúaL¡7W._Šv½‘4c×C€©Sùß-rmw°;¾‰#ÛK—€«hu«ŽÉuõCÁð›ã›òrÛÍ>(=’ýVEeeš0&Nú¹éåZ»{™”Ñ96v=˜ž#~çå— ³jV¿XUXV¦ cò³Ü›1Ù{Ñ[Íî)–eôFÒŒ]¦vå7‹¥yð1áã.cJ¯Ë¿öšø4‚Ý:&{r`ÛæØ6R¿z‰7¯÷ü¶© L,Å0‚Ê4aLø;ÙìOì±òO#ï"z#ÇÆ®‡ÓsÄï¼*~£Õè—>«Fq…i˜üæé͘ض0¤‘ŸvôFÒŒ]¦vå·ÁŠ·SòLio+çmö8+Gû‡“ý³É˜¼*ÙÂDÃW;XæÕÊïýrPuL•i˜ŒÞ§r¤7ð"_åÜUôFŽ]¦çˆßy¹ç7ù©÷ˆÎZ” T¦ cÂôÙ9øITç(7ß¼Ë褻LíÊoVˆ!ا㬒â/ÙŸë×w5!ènKÛQ–ëë‚u+·,~£Rôk:¡œ+Wš&Œ þ3‰'è娭h—Ñ96v=˜ž#~çUñ;‘_5Í>Šºl{R™&Œ ‰>QïÄD/E»Š^'ÍÄõ `Òvå7KNÁþícÊö , ìôêmÛÀî2&IN˜8úˆ•o^IÑUñ[ŒŠ€A%«†bAeš0¦ ŸK‡N3B½í*z#ÇÆ®g“>GüÖUñ›maOA“O/ÅW¦c"Æc²÷ª“4—¢]Eo$ÍØõ`jW~s/ 5( !í2¦lX ¡ýÕ›­u_OŽ mé÷¹üU`Z¿Ñ;je㙋Z¹Ú4¹©>\éžöz[9ÅŸvôFŽ]¦çˆßº*~ƒMšm}W 0U¦cbcâÞh½í*z#iÆ®‡S»ò›• ˆ÷z~{é Øû Úrâ׸¢-ƤmÓØñ«–ºZùùÕ2ûh†XSašt°ðö{7c¢Øë. üÓŽÞȱ±ë!Àôñ[—^ú1)PÊI‹^9µiƘ8þ‡1uiö=ŲŒÞHš±ë!ÀÔ©ü6\a£z‘Pa³Qœ×WÆU½æ`»ŽÉ¨–(yC†yiç¿ÓªøÍ¢^±m)A¹¼Ä[š&Œ)áï$$é1¦KÑ®¢7rlìz0=GüÖåÊo#ýÑ+Ë´8Ê­L3ÆE>ŒÉ¤“4w9w½‘4c×C€©SùmA²ßÛ¶c²Û(ÎÇ'ñY¼y¯µîëÉèmO0hün£8]¿s„ès‰ eíoú›c•i6íYèSù ª=Ƥ?íè»LÏ¿uUü†d»…h¯RYù]™&Œ âGÒˆ(—.E»Š^%ÍÌõ`Òú«{3&â÷<Ü”7G„£k„¾µ¶u‘mÆä²y2ºD>Øî{Àt}=óK^‰~u0þC_›fŒ)|:X·uL w/“2z#ÇÆ®G“ý’O¦ëóž'mD ys±À·rµi˜búÜcŠˆØ®Êµh?í褻LíÊoF Á~mF¿¸¸©1åà½ÐÖñ«™Ó–Æ„¤É Éûgâô<ð_€iUü–ÌâW‹YËS¹Ò4aL¾Ÿÿô•ÏSÃ¥hWÑ96v=˜#~_Ÿ÷JÒ$Û6„dÛ°TLâ­M3Æ’Sgÿ¯~ÚÑI3v=˜:•ßìsÊÄ6Vy¿Ž)Aöæ%ßu;[§rL í¿0~±Žéúzæ9–óúÊüzN±•+MÆÄ¬·lfù¦=V~•sWÑ96v=˜#~_Ÿ÷BÒØŠ ö xgj)ÚžT¦ c Ÿ:&g ¤¹í*z#iÆ®‡S§òÛ¯»EûHÀ`b{|“—m‰x!†í:&ãZ¨ì³åtÎÕþ˜VÅo/÷D#Xöqpq*W™&Œ‰ð£1éÓ¥hWÑ96v=˜#~_Ÿ÷Ë}k …ÆT™&Œ)Óo?¦ÒÙÊÅ«œ»ŠÞHš±ë!ÀÔ®ü&`¶­˜ßååù<Ü‚1a€äÝ­8e‰»uL^BFÆ—¡Ò;X^_Ï<Ç’÷JÀÌdä1så*ÓlÚ3Å»ƒøÈÍNŽ]åÜUôFŽ]¦çˆßqUüfÍÁ»×Û{Œ©2MSùhLF™z«Ù¥hWÑI3v=˜Ú•ߨ~GŽD@wOåBÒ˜³&ÐÀa·Ž sÎöhMÉý›åqUüzÍíÍ‘R)~W¦Ù´gƒ£›1…ئñR´«è»LÏ¿ãªøÈš×—•WR*ÓŒ1Åÿ0¦:'&1ÿ´£7’fìz0µ+¿Ñ¨Ž­±í`kï[ñÐ,ÈÉ6ƒq«µîëÉ“ªa“½b_¦UñÛ~“ÐÇr,ê˜*ÓlÚ³ÆO­œBîˆßñR´«è»LÏ¿ã¢øí3Ûmg âŠýeš1¦@ôaL!v4&?íèuÒL\Ï&hW~SÌ~Ñ-kÕ©ÒSt°dŸÅk¯P’¸%~¿žl“SÌäÇ™_&Xn{bëŠØ?Ñ`Y+Wš&Œ)â§¹ít¥Lp÷2)£7rlìz0ÁsÄoX¿IÉöH™"ywŽ?Œ©2MSŠÄ÷jH:4.E»ŠÞHš±ë!ÀÔ®üö™p>rRD)n§WQX²=ìmå^OöÏÊï¤HÐ/¶=¹¾žyŽÙܱÒVb*ÚžT¦câßÛÞ¡»“c—¢]Eo䨨õ`zŽø «âwoƒ‹¶SJe?æÊ4aLé?Ý‚ôh6ÐO;z#iÆ®‡S»ò] ¨™ã}½̘(#²‘Cvd¡­á¯'g’œ¢ÍÑt ¿ÓòÀKÔWïZ/G+SešM{†læe$+)pO±,£7rlìz0=Gü†Eñ;©½<ÞoÒVŒb®\mš2&þcê]°„·¢]Go$ÍØõ`jW~û­+oCi†ÒæÀKC²èšP”^ÕÎ$^dRDbƒŽ©ºõ/À´*~£_Ú¯!ÜXœÊU¦Éíá“c9vÆÐ+\Šv½‘cc×C€é9â7¬Šßðú>ìÅ7–\ŒoªLÆd»–ÏjbgBþiGo$ÍØõ`jW~ƒ2# QeÞyûoÒ0ðù "×ýÃÆdph”wJÌ_eL«â·wlGÌ…˹r•i6í9üæX¢Ô“ .E»ŠÞȱ±ë!ÀôñV+¿“¥±¯D™ŠñM•i˜$ʽšiÆ÷ä :ið*箢×I3q=˜°]ù 6æhhçeŽ“&£ˆÆ9Åþ܈[[92«Hd¿0ò7ïÊáªøŒÚo•äêõ§À²0MSÊü¹]0v€ ãO;z#ÇÆ®g>GüÆåžß$Ñ…Rµõ¢ìù]š&Œ‰g~yi v€énä]Fo$ÍØõ`jW~C0Ö‚À^ÇD›Ãl3á­„IÐþwOå *e²M‰|u|ÓõõÌs, ñަ`°¿+Ó„1¥ø¹ß%÷.ñâÝÈ»ŒÞȱ±ë!ÀôñWÅoz5:bõ†ÅV®2MgºW3õ9`ºí*z#iÆ®‡S»ò;³ª·j ïA'[/S~•#Ùê_[—S¹Häu÷$θ¾y*‡Ë•ßA|4zVÔ—xÿš&ŒÉxè‡1 ÄŽ\€w9w½‘cc×C€é9â7®V~SÊ!©óò²*·6MÓ‡1]zS#i®rî*z#iÆ®‡S»ò;F㌨Y~?–Ť£Á¶c2+îV~{?_q¶ýà|>˿Ӣøíå¢Þ)E ÌþæXeš0&†ÏŸôšSÕ¦ôÓŽÞȱ±ë!Àôñ—Åo´muòr@,ŠßjÓŒ1Ág®¼ÚF;Àt+ÚeôFÒŒ]¦våw4¾D™lYO1l– ØëÇö7sòQ)²Û]À˜+æ`Vˆ"ß<•ÃåÊo×ñ_m5¡hW›&Œ‰ ²oÆÄI;uLx—s—Ñ96v=˜ž#~ã¢ø­þ/µ·Ç¾þ+LÖ¦ c¢ ·¤áUÏ`¢ðÓŽ^'ÍÄõ `¢våwo¡á׎%Ñv£8Ä„J¶VÚž’!¨Pö**?Oÿ0Ѫøm܆ÀÀ’™Šf„µi˜è?· (÷ڞХhWÑ96v=˜è9â7­ŠßéuáÓ D‹ÊïÊ4cL)Üý˜ÕVüÎVŽà§½‘4c×C€©]ùí[)˜ókc’l¤‡lhèÄ[­u_OFf¿õõÝeîkÀ´*~kŸ=â½—Ã_³6M0*wê˜èR´«è»LÏ¿iUü$~ݶKþÒìÚ4Ó˜øsÉöë¡Ç˜.E»ŠÞHš±ë!ÀÔ®üŽ>L7«ýÊȲ;Œ@Ñó:?„·Äïד#Ðk^¦ß!þ&0­ŠßÙ«=Ù§åiu³4Íf†ðéùe §s*GüÓŽÞȱ±ë!Àôñ›VÅï(BN‹£ÜÚ4aL¤ŸI¼jl:Àt)ÚUôFÒŒ]¦vå7@`Û€¦m/·Ù(cÔàuôlÿc¯µ®?9ß äzßÕ˜hµò›$Ù&ÉPZ¨¸Y›f³ í±7còÃÚ0]åÜUôFŽ]¦çˆß´ÜóÛVçÀ">S«ìù]šfSúô%sª:Àt7ò.£7’fìz0u*¿Ñ¶É… …½I¼Á€IÈ‹Ü}Æ'æÝžßÎ*ˆ} ÑWÅѪøm_Ø'A†$EomšMâ!¼ü™{Àt)ÚUôFŽ]¦çˆß´ZùÍ®°&(ë˜*ÓŒ1ág‚E–”:•ß|•sWÑ뤙¸žLÜ«üFop‘·G„jPQ{©i÷TŒ¬úW{0Î+¨þ˜xUü¶×9#„¿E¼µi¦1Ù_öј¤w*Ç—¢]Eo䨨õ `âçˆß¼\ùm; Ûø¥à0•¦c"ºßû†¹#~ó]Î]Fo$ÍØõ`êT~§’*°7ÈÝeL@ ¼/A´ Æö”oô2Áü<ð_€iYü¶meô//Ú†¼dL…i˜"¦øaL1÷€éV´Ëè»LÏ¿yUüã®Ù6 ä·>ÿSeš1¦ø©1ÉÞ|±L—¢]Eo$ÍØõ`jW~#E£,¯ Ⱥ7%ÅJrÒ$ÅÈ»“íá0àk‚«Ã_¦Õ—¶µô]öÚ£rAešM{&ýT~#p§í óO;z#ÇÆ®‡ÓsÄo^¿ýËN Õˆl)~¦ c²Ö}bb0òîÍÜHš¢]Do$ÍØõ`jW~S´M¹,Æ”7ïÊyWFƒ$L°5ðòõdzu¿¨÷Í–¼Üó;øOïUmå*ÓŒ1¥ýtìïT~óÝÈ»ŒÞȱ±ë!Àôñ›WÅoÛ$‰pâ ¬ü®LÆ„ïÕ,ßÅ;¤¹í*z#iÆ®‡S»òÛÖßœ²—: Ä­+)>¤(7·ŽdÛ Ø­c¢ÕþííOòWû1ñªømðìµè¯ÞÈ©¦Ò4›öüßÙ…Ú»+Ç—¢]Eo䨨õ`zŽøÍ«â7Qµ’R⢻@eš1&Û‚ÜŒ)PêœÊÉ¥hWÑ뤙¸žLÒ®ü&ËsÌ ¬†L[â|¬cH1eYé‡k»Œ‰|,„7Ø öÁ}˜d½í Úé5E7§r•i6í™ÃçT¤×ZW>½LŠè»žLòñ[VÅoÑìü “D-€©2ÍSä»ò;)¾…ðFÒ\Šv½‘4c×C€©ÓóÛ‡M©p„x•tíÔ1Ù_ŠÞŒ#éÖÀK²W}¡_Ù˜Ïgù`Z¿mcÏ1±}ZäXmšM{Îò™ÄãGt`ŸvôFŽ]¦çˆß²Üó;hsÑ] 2ÍSŒ÷j–4@§ò[îFÞeôFÒŒ]¦vå7ûà&°débHYùm¼@m'ˆ Ä»Œ‰g ™¿y%EVÅo/Ddfß_–,…iƘBøtÐŽø-üÓŽÞȱ±ë!Àôñ[VÅoþ/Ÿ¬U0¦Ê4YÍñ®cJ^ ئKÑ®¢7’fìz0µ+¿Å@A‚—;nÞ•K!qé<‡vçÊÉ«S8’ýæ… ÿL«â7ûa<ù7©`L•i¦1ÑoÏoã…+)r)ÚUôFŽ]¦çˆß²,~ƒ-<>½UR(Žr+Ó„1Ùæü>~J´·•»í2z#iÆ®‡S»ò;yiCôÕ!Å­¶'^F˜Ø ,úE‰MÆ”"#Ú‡†d¯î7Ëd¹íÉ«ÌT|6q9ð¢2MrÌOA>Œ)ôúÊËÝˤŒÞȱ±ë!Àôñ[VÅïÀ>æ6±÷Ó.¶r•iƘÜ«™­Ø=ñ;]Šv½Nš‰ëÀ”Ú•ß9 eƒ‡€H{“xýõ#켦îÖ1˲²Í/aúæV.-¼Ì>¾¼ß•§r¥i¦1¥ðé.` aGüN÷Ë2z#ÇÆ®gSzŽøVÅo°W^½ºŸ9—x+Ód5‹œo•Wleë0¦?í褻LíÊï,Q0eŸWC¸;ðRXeLàTq·ò;³‚ë[†L¿9%%­·= †Ï9{{yW®4ÍåOÏï BZÀôéeRDo䨨õ`zŽø–+¿½›(½´(;X–¦Éjf„æž’*"ЩüNw9w½‘4c×C€©]ù­(Y"G¹[­3&bõ=œI°Ë˜Ôå%d4ât@| ˜VÛžyäì‰)¦˜*ÓŒ1qºuL&íLIIW/“*z#ÇÆ®‡ÓsÄï´*~Î9‘ÚòìmÞŠ­\aš1¦(÷èbP§ò;ÉO;z#iÆ®‡S»òÛû}'4˜Ø¦÷¦8ã ”÷.ñ¾žœ(ÚÒϘ¾ÙÁ2­Šßù5NÒG/A,¶r•i’cFi>•ß‘©£1¥KÑ®¢7rlìz0=GüN«â7E#°Þ71âweš¬fA>så}ÓéÇ”.E»ŠÞHš±ë!ÀÔ®üÖìeŽÉ¨£êfKc:Fw^cáô ð[Œ))dÛËé—iy७(ùu­˜+W™&9–…ÅNkÝtO±,£7rlìz0=GüN«â·÷ÇÈÑÞùü˜*Ód5ó›£7cŠÚë`™/E»Š^'ÍÄõ `ÊíÊo{mÅ6;>èœ4>wØwrö–\Ýv&ñªWgŠ16M@ßÜÊåUñÛIˆøH±TæXmš1¦5¦Æ”/E»ŠÞȱ±ëÀ”Ÿ#~çUñ›‚w_G°o†Ê+)¥iƘîƘàº?ÚHšKÑ®¢7’fìz0µ+¿5E¶—ˆGâî$Þìu‘|¸£×"í“?Y¼â›0Rýæ©\^¿ÅûÖd/ÚÆ—ÃOåJÓ$Ç è?uLÁ;X´éR´«è»LÏ¿óºø­Þˆ•R¨ÄïÂ4cL úaLÜ+ÈE»ˆÞHš±ë!ÀÔ®ü¶o€lÑ~ñyçí¿IclI…^µîj[‹]Æ”½Ý7zûKŽßìÇ”WÅoÛ'I|Á¬åÈ_`ªL“Kn÷ÚžäKÑ®¢7rlìz0=GüÎ«â·øD­à»†PNI©LãÕLõÝ0Ñ×|Vé“ü´£7’fìz0µ+¿ýÂ1ñ¹Q7çÊ “OE÷ ~0·Ë˜ˆ²—?2Œú¦Æ”WÅo'9¨Úÿå²À²4M“ÜmO^ !uê˜ò¥hWÑ96v=˜ž#~çUñ;·ña)Jy*W™Æ«™w‚—P˾™èÓ¥hWÑI3v=˜Ú•ß¶¡çK¶=ˆ°yWÎÐȧéfò‘Õ¯Ž[ŒIì'ùuÅBæ5çÿL‹â·O"oC eϯÊ4aLÿÒgÀԻěõ§½‘cc×C€é9âw^n{¬)iÙZ·2M„›1y‘_˜ôîeRF¯“fâz0i»ò[‰ARbæßþùKIcŸ^Žþ³ÞÊ)pÞfL~F½ÎÒyÀI—ÅoôÊʪ~L•iʘ®ñMΘbîÌ•Ó[Ñ.£7rlìz0ésÄo]¿ùÈXð[B¥ø]š&ŒÉ›ßÞŒéž1ßHš[Ñ.£7’fìz0µ+¿íÓHbôNo¼©11ú%w >M(‡íS9ðÛ;œÕïê}ScÒUñ›ƒ²2&âµU0•¦cЬÕÌÝ»í*z#ÇÆ®‡ÓsÄo]xéŽ)`(;XV¦ còI¦7c¢œ{IsO±,£7’fìz0u*¿cô KA ˜7û1ÙÎ9bŽ9ÛÞwSÈ9#F¶½ÖWËt¹ç·rÊ~  Åµ§Ê4cLïS9M¶Purìnä]Fo䨨õ`zŽø­«â7ªD¯†4“¦2W3Û;ÈGcŠ×y#i.E»ŠÞHš±ë!ÀÔ©ü†àG“‚^S´©1‘mã¢@Ê)3½¦o1¦˜ÈÇä2¯ 'ÿ`Z¿]dH,9âweš1¦ð¹xhÀÄS/E»ŠÞȱ±ë!Àôñ[—^ú Ø ‰©hâU™Æ«Yfx±¤cò7£“4÷Ë2z#iÆ®‡S»ò;'GS$ƶçʹlͼ`€x—1å$¯bö¢óoöcÒÕÊoPË+)•i˜,îÛJ}¹à*箢7rlìz0=GüÖEñ;Ù–+ˆØ¿C€â‚eeš0&òòÇ‹1Ðæ•”hÿþiG/“fêz0ù/ÙdL>ŸÛ…¼7¾)üÄõ)û…½ÏÀ&cÊj°”½„9RøÞVîþzrÌÌ:ÒòßÖ:µi˜ çï?I‘ÛÍí7ûU´ÿFo䨨õ`ò_ò!ÀtÞó¤ÉüšDMl;þ Lµi˜l{~kL”Ch¶=±ßìžbYFo$ÍØõ`jW~g2FÁÀ^„¿Û ‚A¼3’ôš*´Ë˜È Q•¢a9NÕ­¦UñÛï{¨ïN¹,°,M³Ù…WB¯WåÞâw)ÚUôFŽ]¦§ˆß÷ç=O?˜föÍ’½þEee¯fÉ–ê»?5¥zIs7ò.£7’fìz0µ+¿³áh"û…“—bovp²$ÞˆÃp)ìÖ1ù\PÛú²ØÎ7|¯\àþzæ9öš÷ŒÐbÁ˜*ÓlÚsú싳Rj޳ßì*箢7rlìz0=Eü¾?ïyÒø-ñZ9‚Ëî¥i¼šùM¶»ò›î‘f¤‘ŸvôFÒŒ]¦vå·í?Õö>7§mÆrˆC /°ßaL®˜C Ø›®|˜Ö^!±]©Ofø«cÖ¦c¢OÏ/Wñš=¿ì7ûL±,¢7rlìz0=Eü¾?ïyÒdçû>+(g?àÿ{%¥4MæÏpFÂk0a#iîFÞeôFÒŒ]¦vå·kbÞÆÒЉ·û1Ùë§¢ýÑu«ÀòõäèWZRP¿ýõM`Z¿Ùv¥Þ+!‘—ÝþÕ˜JÓl†ÏìB¢ö´gûÍ.E»ŠÞȱ±ë!Àôñûþ¼çI“SpMs9¾¹6M¾ v^Œ %7kL¢ýë§½Nš‰ëÀÛ•ßì-âÈÇëy«ò=Æä…ÛÆzŒ/¡àk7FŒ‰½¨Eáï• Ü_Ï<ÇŒÙRªq8Ââä·6Íf"~SÈ©£cÆKÑ®¢7rlìz0Åçˆßqyà¥ë7ÌèmÁ˜ Ó„1ÅÌÆצFÒÜS,Ë褻LíÊobɨ.~insJ «Ï^ÀD ®ÑpËÀôz2bœDSøâ•”ûë™çXb'€¢ö-f,ê˜*ÓŒ1¾w§~êØaLñ.ç.£7rlìz0=GüŽ«â·WÚ¾:3T—x+Ó„1ÅõfLpM³h$Í¥hWÑI3v=˜Ú•ßhkppÈR}³Sð³!ÛV çø*(ÜaL˜ØÅ’f‚/^I¹¿žyŽ¥lŸBã7ŠÅ¯6Í&ñð§òÛx¥ôrìV´Ëè»LÏ¿ãrå7ú> üì(••ߥi˜‚­ô7còq¤¹Ë¹Ë褻LíÊoÛ„ 2D ™ÏÃ-4¦Èv­šÔˆÓ«lGcBV•½êW·rË/5Fû¥ÐËÙKÆTšf³ éÓóÛK:,ñžbYFo䨨õ`zŽøWÅoŽ.ùeÛ(A.ZëV¦ñj&^r3¦ø¾ãÕJšKÑ®¢7’fìz0µ+¿1Úol{OãK×\†uÆííËb›ÀÀ†N[Àôz2Ùÿå`+?â÷:XÞ_Ï<ÇŒ¿i ¾»UËÊ4]È¿³ µ›cw#ï2z#ÇÆ®‡ÓsÄï¸*~¿*8¢ßõÑë˜JÓx5“Dt¢°s” —¢]E¯“fâz0A»òÁ3G¡([[¹ð? …øªt§ˆ´{*‡>JäUaáCí¾L°<ð’"Œ¤BÅV®2ͧ=^®9vO±,£7rlìz0ÁsÄoX¿mPIâ—ÑB1‰·2MßWRþ\Šv½‘4c×C€©]ù þ #y½:í5Šó»rÞ¶Ä÷‚˜y˜^OÆlx¦^ÊDÓ ª¦Uñr4pöñ^Ša•i6»ôÓWÞ›„vrìR´«è»LÏ¿aUüfŠloQÌeÒÔ¦c¹OåP»G¹p)ÚUôFÒŒ]¦vå7x‰%9‰TÖÍ))~Òoh¦hû1ä­ËדÉp_CBaº‰ü`Z¿ô5³Í¾ÉŠ1•¦Y_yý³ ç.0]Šv½‘cc×C€é9â7¬Šßà½ÞÿSeš0¦ã]ùšÚÃ|bÁO;z#iÆ®‡S»òÛvr‰_CN £7Oål#†F™ÐÅoÐÝîàõ^¶4düf¹,‹ßn`ßa9¾©4Í&ñ$þ0&#…+)p+ÚeôFŽ]¦çˆß°Üó|ª¢-ÛkThL¥i˜P>Œ  Ç˜îFÞeôFÒŒ]¦vå70'ßÌaBЭ+)^7I ÙCŠo»SR€}QÎ,hÛ¹oÓªøíWo³Rô;KEÛ“Ê4cL>³ Qµsò —¢]Eo䨨õ`zŽø «â·¼[kú«¯¤ü5M“ÄOå·7µéÐl ?íèuÒL\Ï&lW~ÛºkBŒ¶—£ù¥Bc’ [Dï]Iy=ˆªøà75&\¿€—ÂÛv¼,°¬L³I<ó•cBîˆßx+ÚeôFŽ]Ï&|Žø«â·mºlƒŒþÛ·ò˜*ÓŒ1‰Ð‡1Qï‚%ÂO;z#iÆ®‡S»òÛØ£×ê1LÌ»"S| à"ïO°ÛÁ¼ß'ûMîùõá¦å¶')SP´m-¤âJJešô•O,|÷üʾ±oçØÝˤŒÞȱ±ë!ÀôñÅï”UIm‰%äP6Š+M³S9Nø{*×kIôÓŽÞHš±ë!ÀÔ®üÛÌfM9#PÜì.€^È!Ñ-ÀÝ:&° mÓ“à›ÝpYüÆW‹?f%E?¦Ê4cL¿¬œ5õ:Xà­h—Ñ96v=˜ž#~ãrå·å—q?‹E¹@eš0&|W¾Ö|[wzIs—s—ÑI3v=˜:•ß18˜†ìá_€iUüõ){¶†š…ÆTš&ŒÉ(ägv¡toÐ¥hWÑ96v=˜ž#~Ójå·ÏÍ^³~%òïV®4M“ß7ú0¦Ð;1¡«œ»ŠÞHš±ë!ÀÔ®üfÌ>„WÀgìv° œm($$UM´L¯'SÊÑÞaàojL´<ðÄ›°)Xyeš0&ÿ›nÆ$±WÄK÷Ë2z#ÇÆ®‡ÓsÄoZîùmlêÊÅhÚ4aLôž+‡~µ“4w#ï2z#iÆ®‡S»òÛV^[Ò³½IYv'ñzwÜ T]ûΛŒ‰m¿ÃÉ{H”oXÒråw&¿ŽÌÄ€Eeeš0&ûL>§rœ{ÝåÜeôFŽ]¦çˆß´(~{¹«wÓfoNVL°¨LÆD’îmt÷ÿù§½‘4c×C€©×óÑ[³ùÞ<•‹JÑþåIW'ÐÆ$œÑžüëßl{B«âw´ï.Å׸ÒRü®LÆ)NåX¤SÄK—¢]Eo䨨õ`zŽøM«â··̉¼ì¦ßT™&ŒÉ77c ¡W.À—¢]E¯“fâz0q»ò;¡_ Éࣵ“cŸrî"z#ÇÆ®‡ÓsÄo^¿CDïd¯9·…0YšÆ«é»q×kÍ·ÍWç_Šv½‘4c×C€©]ùíL‰“kñ¼›ŒIĶr^*ƶvOåRö¡lÛ9Á¹ìþ/À´Zù­1J _/K¹ 4M“m>§r½á|•sWÑ96v=˜ž#~órÛ“LÙk¶Ùû„[¹Ò4^ÍHàs ôªrùîeRFo$ÍØõ`jW~¿Úê:”úIô.cR|µ'Ø[±œ+W™&Œ S¸kLÀËr;I?í褻LíÊïlž8x ›“Ï9ñk%FœbÂ-`z=9Ú&G¼1ËôÉÿL«â·W‰¢·Îó0…ÆTš&Œ Òï´g5:ÙɱKÑ®¢7rlìz0=Gü–Uñ³íÛ9’·y+.ñV¦ cŠ?ŒÉPª³ÿ—KÑ®¢7’fìz0µ+¿3£D"åov°ÄÈF˜ ŠéÝ3eSc²MI`ÛJ.ÈîÿLË/3"z'-ÆÐצ cø0&èÉrO±,£7rlìz0=Gü–Uñ›Å§Ü3ØÀ0U¦ñj†zŸ ýßëÀ»—4òÓŽÞHš±ë!ÀÔ®üÎâÍ…|¾Ünw4¶dÛ9y5mÆÄš$±R„€ßx)=¿)Ú?öÎSYù]š&Œ)$ 7cr(éäØo#ï¿Ñ96v=˜ž#~Ë¢øí½[cJYbQù]›Æ«úT›1Ù»Õ¹’"oE»ŽÞHš±ë!ÀÔ®üö»jÉw¢»§rFu˜Ø÷b9¥})‹ŠëéÂyà¿ÓrÛ…¤"š hË’”Ò4™öì57câw¯ªVŽÝ½LÊè»LÏ¿eUüFˆ¨ä§Ëá¥i˜rÖ»òì[î$Mºí*z4×3€)µ+¿5xIVu˜Ø­üÖ(®~B ÝeL¶í'Æ.á«âwZ¿-¼,ËX`Ô¢KjeçXâôé`Aܽö”.E»ŠÞȱ±ëÀ”ž#~§eñÛ¿_ðÎÔ‹S¹Ê4aLÞÿfLNs:Is+ÚeôFÒŒ]¦vå·fŽmÖh›ƒÝ:&ŸFàš½/i·ŽÉ+²c“±.üfåwZ¿ÅÏ.‚—£…BcªL3Æá¾¢CtIh»í2z#ÇÆ®‡ÓsÄï´,~cŒX"å²íIeš0&¾·r¶æûä¡NÒÜŠv½‘4c×C€©Yù A${µ@ò ÇV£8ט¼¦F½®Fu·“=9ø-^Ÿ&_m—VÅofWÍürN©1•¦ c¢üé`áógzŒéR´«è»LϿӪø½{” ˜¨˜’R™&Œ‰à—1… S¹t)ÚUôFÒŒ]¦få·-ì’#‚‚\½Í¶ê˜ŒÚY}öc²'‡ÌÂ`/ñwOåÒªøŒz·î×oô˜*Ó„1Ô꘻¬üR´«è»LÏ¿Órå7 ±ð–fÅ©\iš1¦(ùØ޽ª[Is—s—ÑI3v=˜Ú•ßFuPm_€blo¿ò[(ØßœøµåMÉG£‘ýc}³çwZ­ü6Åœ2ÄòT®2Íf¦ðé’ê§“cW9w½‘cc×C€é9âwZ®üΘ}ÖO eåwiš1¦ü9A²e;uhv¾Ë¹ËèuÒL\ϦܬüEàq5Ñ{FãV“—ú%ûùì3&bN !Ús+—WÅo~ïÏ¥eÛ0[¹Ò4™ÄÃø©„÷ê¶+Ïñ§½‘cc×3€)?GüÎË/%»aëzäRc*MÆdïÑ­1¹Û¹’’ï)–eôFÒŒ]¦få7ؾӛÄIo·Ë˜RÊÉ6‚ˆ,w5&N¶þg¿¹ÈóáäÿL«â·±ÿ2Ø‹_1¦¿¦ c2*øé’jfoñßvôFŽ]¦çˆßyUü–È)5PI±FPš&ŒéE‚ß/QT’Žø/E»ŠÞHš±ë!ÀÔ¬ü6Æ”Œ±Ÿ¶û1i6ž|0dÚ<•³'ûÌKÎѹ¯Ó²øíS—ŒÞ¤±¿KÓ„1…Ÿi϶Pu¶rùV´Ëè»LÏ¿óòÀK¤ˆ^7coA9"¼4ÍSDü0&„N?¦|O±,£7’fìz05+¿·ä×UѴ͘PÈPÞþð´ÝÁÒž ™#D"ñ›–y¹í úý½˜Œ†’1•¦I—T¥ðaLÞrª“cw/“2z#ÇÆ®‡ÓsÄï¼,~# &ÎIHŠËÊ4aL>w墑›Îu|+ÚeôFÒŒ]¦få7°˜Õçl×1Ù ÷j.ð={‹1úÕa§\)~³Q\^¿Álj…4cQ+W›&]REógÚ3æÞ]¹|)ÚUôFŽ]¦çˆßyyà%ùœ!²UVB¡1U¦)cJú˘°“4zO±,£×I3q=˜´Yù ÁÞ[@x5G‚Ý:&_µm£âcay÷TΞ ¶‡Ì~#FçTÿLº*~ë‹Á,Q)~W¦ c"ÐÏ´gìÈz)ÚUôFŽ]Ï&}Žø­Ë/²U´¯#å•i¦1Éç%ŠÊÒ¡ÙzO±,£7’fìz0u*¿“žú|c{»uL1ròrÒôËB—’æõdn¯˜Ï"øfå·.W~{+m4®±ìù]™&ŒÉ/ÙÞŒÉ>ÛÞâw—s—Ñ96v=˜ž#~ërå7g5Âl_KÙö¤4ÍS ú0&ÀÎVNïrî2z#iÆ®‡S§òÛWß5Á®ÆäE5®€ ä7óÜ«ü?`ÊÌ‘ãWÓ²øM>PÃ)€©2Í&ñ¼'£¼•8êæØ­h—Ñ96v=˜ž#~ërÛ“ lë²ØR¡…ø]™¦“ü2¦À&^z÷2)£7’fìz0u*¿U(’±ÛÒ¥]I\ìÒ˜¢ð–øýzrð9À¶#˜?ù_€iUü¶Ý¥×?ç-Nå*Ӥ痦Où„mêr•_Šv½‘cc×C€é9â·®Šß’È'$úMm,€©2M°Þ=¿£½ëz)ÚUôFÒŒ]¦få·íÅȶb!úM‡MÆ$âkm+Èò®ÆäElÑg‡ ù›–º<ð2ÔÚ^)”%)•iÒ%Õþ´ûT2i1ÝS,Ëè»LÏ¿uQüNÞVÌçx@ðnÊV³Ê4aLNmnÆ”t7“&†ðÓŽ^%ÍÌõ`ŠõWß}_з IßKvS¶­«GÈq ˜üÉ"ÆW½¦í~¿X.p}=óË!’x=¦F”bñ«L³Ù…!ý2&éˆß1ÄŸvôFŽ]¦#~_Ÿ÷BÒ w´—^áïþ¿6W3P[ÂnÆ”¼ÝV;iîrî2z#iÆ®‡S»òÉ”EöN?¸Ûó;g?ê^Áºu%å5-Ó'ðÙ–'#ÌŸü/À´<ð2€ËÊhUY.P™&SþôüÒw±e+Çî)–eôFŽ]¦Çˆß×ç=Ogû mÇ‘|vë_`ªLãÕÌ›OUní´=‰áR´«è¤»LíÊodõ9aòΞ›ŒÉo¤dÉbˆ¬Ûwå£fµŸ´w-}Qü¾¾žyŽ%A¿¿g†S.4¦Ò4Ó˜ä3©]ùÃ¥hWÑ96v=˜#~_Ÿ÷©ö«À´*~§Ê̪L¹8•«L3)Åc²O§ÇÊ/E»ŠÞȱ±ë!Àôñûú¼çI“!¡ß`H>óµœÄ[š&Œ) ý2¦€íK¼¶ÿiGo$ÍØõ`jW~ÛN.PKQw똄_](])BÞ­üF㈂R üÅÖº××3Ï1ã ¶CbQÛ‚•צ c²mýgOæN¹@ W9w½‘cc×C€é1â÷õyÏ“&{O¹œTѧ÷'&¥i˜ä?§rü³ÓHšø™bYD¯“fâz0Åvå·o:¢1¿3GÓ‹!cJ(‰‚“a löüÊ9dòY_¦¸*~N¾!—âweš1&ÎñؤsíÉþùiGo䨨õ `ŠÏ¿ã¢øl™ðž÷àÃ5Šë•i˜(}„ÚèÓ/;I?í褻LÍÊoÄÉàTØ`i~6V0&µ×ÃÛòf²ÅVkÝ×tvñ&PÁ'hϯÿ 0-Šß9¸|cPm°” *ÓìTÎ?Sîé˜ÚÑ96v=˜ž#~ÇUñ›ÄVï„ëÃÿ&Meš0&HŸÕ,ãÄKÑ®¢7’fìz0µ+¿S|Ítõ¡“<¿J[0&âã*%òõ{1¥ðºôÅöžEý¦Æ—ÅïøÚøÅèE]…ø]šf§r¿· @¹Óö$Æ[Ñ.£7rlìz0=GüŽ«âwñá­\œÊU¦ c‚ï›ßrè­f—¢]Eo$ÍØõ`jW~ Kv„°Ýó;Aö7%y'Ò°9W„ìÇAÑ/ò|˜VÅoˆÆE  !Ûoõ˜*ÓDc2öœ?ÓûÒx+ÇÒO;z#ÇÆ®‡ÓsÄï¸<ðKÈœ^c[ÿ›4µiƘ~ï1EÐØ®ü6ðúiGo$ÍØõ`jW~óëΆ_tþ³}WŽÀ×nû5o‰ß/u $Ws%Í'Úý 0-÷üö«DÉ`Ò¾ÁBü®L U>“xx;9v7ò.£7rlìz0=GüŽ‹â·_Ǥà­\µ˜Ä[™fŒ)}îuÃéÌüŠðV´ëèuÒL\Ï&hW~c¦×þ“ ™pWcõ®ûì}Sˆ·ÊüÉF¶ìõu¥ à‹ý˜®¯gžc)Úš"‰(#HL•i˜BþÔÊÙF;ÀW/“*z#ÇÆ®gšÊRÒøûª‘ÀÇi}q|ÓõõÌsÌ6”ÙÇo1úT¯¿ÀT™fӞçÕ0ÄÛÝl=øiGo䨨õ`zŽø ˕ߙQ¼éV L•iƘX“@çÄîrî2z#iÆ®‡S¯òÛ~ë”TIßÃc¶z~øRÌbÚfLlŸ–±-ûÝô›À´\ù ¹;”,+Ó„1‰æû>&Íé-~w9w½‘cc×C€é9â7¬V~»Äsòî}±8•«LÆd‹ÍçT1÷öÿW9w½‘4c×C€©Sùm[*#.^ê¼Û] P2¢>þi·“×V&#k¯K<_eLËmO„¢­(r1Œ 6M“íŒ?³ ãû¦A+Çî^&eôFŽ]¦çˆß°\ùmù/Fþ%`.^–¦ cŠ÷8k?•“N?¦ˆw9w½Nš‰ëÀ„íÊo&öFRF™\ßÕ˜"Úö•9©ÞÚÊù“ígÙ2zÿêo2&\¿}’•÷‰C9‰·4MSâ$)t¦=[°ŸvôFŽ]Ï&|Žø«â7IF)ÉeSeš0¦HŸ~ÌÑo¯v’~ÚÑI3v=˜Ú•ßL’د†X®o2&PÛQ¡’ÁÞî`éìHíãSVúæ•\­ü¶lô{{è[Û¢}seš1&HŸîFÙ:Œ ¯rî*z#ÇÆ®‡ÓsÄo\n{ýÄË'k”÷˜JÓ„1¡O“·°ì$ÍÝˤŒÞHš±ë!ÀÔ®ü¶=_uCƒS”-ñÛ5¦د”€fÙ¾+gŒâ ß,ÀUñ;‡àcî"Û§r•i¦1åð9•‹œ;§rÈ?íè»LÏ¿q½íIÊÙÞ!àPÔ1Õ¦ñjõ?,#AGcÂO/“"z#iÆ®‡S»ò;¥˜k ȸ?WN5ˆÁûºÛcJÅçÊçŠøÕ­ÜrÏo ÞïH  ©2Í“QÐcBê-~w#ï2z#ÇÆ®‡ÓsÄo\¿}¶©e)5¦Ò4^ÍŒÖÄOK¯=ï$Í­h—ÑI3v=˜Ú•ß™’mA%HÈW£… Æ™„dÈ´×ZןŒÉll ð«•߸Zù>Þ6ªBÑó»6ÍSøÔÊÜèäØUÎ]Eo䨨õ`zŽø«â·$b{…‚ñ/ÚžT¦ cÊJ÷ÍoŸ¸Ù©1¡ðÓŽ^'ÍÄõ `¢våwÞ†¢xSàÝ–À>¸ÉûPÚc·çwr®Œ8»øêVŽVÅoVû8¼‚«»r•i˜(~N)£jî” Ð¥hWÑ96v=˜è9â7­Šß¶8'[‡|n[Ù] 2MSþOåw04é$Í¥hWÑI3v=˜Ú•ßÞjÑøwÆJ{â·¿~Ñ«·,†ÈnÏïl$Í^YÛõ ÏÏÿ˜–{~†ù̂ũ\ešÍ.äôé’ªoM³•cw#ï2z#ÇÆ®‡ÓsÄoZ¿Ã²·¬%*ù˜*ÓŒ1AŽÆÄ¡#LÒ¥hWÑI3v=˜Ú•ß9&ïm‡{ã›ìõóñÞÉÛ9Ùk²}*go–ÚN""}s|ÓõõÌs,ùôS/ÙÎÀXhL•i6»»¤fíñÒ]Î]Fo䨨õ`zŽøM«â·7<o+æg8c*MÆ”T?ý˜lÉï%Í¥hWÑI3v=˜Ú•ßjX–3F™×_—=¿ÔVpNÒö\9Í$³½Â(úUÆ´*~«Ÿ1"Nºbö˜JÓlv!¦Ž™µ3"<Ò¥hWÑ96v=˜ž#~Ó²øm+,û9iòéˆÅïÒ4aLÞ6éz‰4§wçÅFÒÜŠv½‘4c×C€©YùíUÛü*€mÇ6“w9Rö–o›Œ ]ßCoDüš•òM`Z¿Y„Tü¨Ð‹àÿjL¥iƘ8ýgÚs¯ç7]Šv½‘cc×C€é9â7-‹ß4Ù;¼„£¿KÓ„1‰Ä{ÿ¯ ¯+õ `â[Ñ.£×I3q=˜¸YùÁ>—¿5¥w5¦Ñ{kŒNœö“Á!*½†ó»:ó[ÀÄ«â·dò•E"ùÍ¿¿å¥i˜"|r̵Ç+çKÑ®¢7rlìz0ñsÄo^¿5'ÑJ`ªLÆ$ô™ù¥ôn­Û¦[Ñ.£7’fìz05+¿½sIï=FöÏÊžßÑKIYTüÒá.cÂ@öaù_¦uñÛ»C±f[c `ªLÆ~úÊ'¥câ¢]Do䨨õ`zŽøÍ«â·±‘øj*µè•S›&Œ‰³~S ïÒFÒÐO;z#iÆ®‡S³òÛ{1!Ûo® °]Ç”5[Êé­_ï0¦BâDÂ@0ïù/À´*~ûc/«fbÚsmšM{NáØö4&æŸvôFŽ]¦çˆß¼(~§„$ÞXÔx*rKÓ„1±Òý©·°ì“ü´£7’fìz05+¿üèY’o=ÂvwE…œÐ7‚›så| „½]ä3Æ~˜–Ûžƒ“Ì"Þ™³È±Ò4›öün÷fLÈ’¾{™”Ñ96v=˜ž#~óªø-B¢9-ïÊU¦ c¢÷ý8_ÍüP(v€)ÿ´£7’fìz05+¿}xËcFư{W.)zñ…ÏoBÝœ’‚¯ærbûÈÌïùâ_¦åÊo¿Iâ!ú}€¿•ߥi6í9ýöü’”;•ß|—s—Ñ96v=˜ž#~óªøí4XœÊU¦c á^ݽéd‡1É¥hWÑ뤙¸žLÒ¬üÆ(Ä~ÒŒXÄÝ:&N)ok›ã½K¼þdÛÃy_Ÿ\œ¿©1ɪø >!g£p’ŠñM•i6í™Ó§VÎÀ·£1É¥hWÑ96v=˜ä9â·,·=!?<òþÔ±˜ùU›fÓÝöÔ“À›r7’æîeRFo$ÍØõ`jV~ã«æ ƒ×2íöcòÉàÁ¯âb&ÙFÞ… ¶éE~wîû0­Šß~Í‘ƒ¡%p)T¦Ù´ç{kë áÕ ³‘c—¢]Eo䨨õ`zŽø-‹â·1c¶7ß¾‘¢»`mš0&ʟጙ;§rB?í褻LÍÊo4$͆KÉ6 :?´/²wVÃ4ÞÕ˜€Ñ·sd¿€Î¹Ú¿ÓªøÍd{qûñ{Ís¬2M“áÇGcbèõ•—KÑ®¢7rlìz0=Gü–åÊoDß3hòš¾¿Œ©2Í4&øeL¶—Ô0ÝåÜeôFÒŒ]¦få·aƒ¢×^;<ðvwW£pÄàÝ¥a‡1a0ªeO7p#ù*cZ¿‰°ñ+?IÅâW™&Œ‰}nvéR´«è»LÏ¿eYüNøúª¥ÆT™&Œ õÓ8?éUoÒHš[Ñ.£7’fìz0µ+¿_­í5€†nkL$`zue‚mÆ”É;=$4Dÿæ•Yx˜³á¥ÿJ…ÆT™f“xX?“-„ñ[î)–eôFŽ]¦çˆß²*~#õ·w !Å¿ÅoµiƘîáÆ˜‡ÎV.]Šv½Nš‰ëÀ”Ú•ß@’£å;Ƹ9%rö+[BÄ~¹É˜œ_¦œY™d÷¦´*~>{»#ÊJñ»2Í&ñüv°Œ¼î)þ´£7rlìz0¥çˆßiUü?Ácbò«Yc*M3Æ$to;’ýÓ)°L—¢]Eo$ÍØõ`jW~ƒßS—W"Ðæ]9È/ö©~âŸw'ñ¢”3ž¥Œ²M7‘ÿL«=¿½U;’_+N\ôüªL³Ij(å•i˜l•ÿ0&oÔ¦üÛËäoô:i&®gSîT~{SûÞ¯Ee³ŽÉgÊ®¼º–åý»r)Go_ÉñU]ñ=`Ê«âwzí’^Sö (¨LÆôs©ÙþHé´=Éñ§½‘cc×3€)?GüÎË•ßÈ’²_aôK$5¦Ò4aL xOâMÈØÑ˜ò]Î]Fo$ÍØõ`jW~ÛA£x¶ îV~ƒ7Ö ŠÁÇŒïΕCo™^‰ð›/órÛŸðî×l¢%)µi6»ðª{Mâ¹®6rìîeRFo䨨õ`zŽøWÅo4FŒÙ·×Zž˜T¦cJpW~'{¥zÀD?í褻LÊoж! ¶»ŒÉv|„/‘ÒvH2DôîXüÕ~Ly¹ç7ú€=Ê‘rÁÊkÓŒ1aú0&oÔݦ»‘w½‘cc×C€é9âw^®ü¶¨f_à `ªL3ÆŸžß¢)wÊò]Î]Fo$ÍØõ`êU~Kðj@w;XB$ö±Æ‰mã’d“1¡ïym#©A!³íI^n{âšµ¢§¦’1•¦c¢˜>Œ)‡N¹@¾{™”Ñ96v=˜ž#~çåžßœlM÷IðÅ%ÞÊ4aL¶ÌߌÉv^Ò¦»‘w½‘4c×C€©]ùmØ6ÞªvOåBŠYíÎ~:¾Ë˜ƒúœ+oÇ@SHü`Z¿%Kôé#¶—òoiš2&Œ¿Œ©w*—õ§½‘cc×C€é9âw^n{" ¯W_¥xY™&Œ)²Ü«™°„0éÝˤŒ^'ÍÄõ `Òvå72@€dïŽ"íV~‡½£• ¢Àö]9d¿Â ÑHÀ¼‚ê€IWÅoBc€ê]µííÿ L•i6íÙßÞŒ‰Rg¨ªÆŸvôFŽ]Ï&}Žø­«â7ŠýC™RŠÅ\ùÚ4cLL÷j&LÐ)ÐKÑ®¢7’fìz0µ+¿Ñ¶c>§Ä€Iæôߤ±˜È˜ ^r¾›ïohLêR[3¯oÖ1érÛÉŒ¤ÌìÍpþ2¦Ò4É1Ÿ2üaL1vú1éÝˤŒÞȱ±ë!Àôñ[WÅïh_y/mÔô7ijÓŒ1!Ü÷˜„®é¤¹í*z#iÆ®‡S»òÛhKJÁb¯–ÜcL19„ m)ò6c¢(>aœ½gh} ˜VÅoÌÉ Z]•ט*ÓŒ1ÅOŽyçà0]Šv½‘cc×C€é9â·®ŠßÞÑÍûæ“j1Œ°6ÍSÄ[¨ Ò¦KÑ®¢7’fìz0uz~ûE9ÒwÍÀfÏï(öž„äuñêkµÃ˜0kö4~•û›mOtQüΠdûR†è×÷‹–Ò4ö Ÿ¹r{â·¦ŸvôFŽ]¦çˆßº*~Û¦:øá2†˜*Ód5 ¶ÓºSÔéù­—¢]Eo$ÍØõ`jW~¨xÓ/HÚ*ðÞŒ~Ý_‹·îXú“}õ÷)›Þó›–º\ùí¯°ÏÂ:••ߥi’cY~SH]Æt—s—Ñ96v=˜ž#~ëªø²Oö¶¯E‚Â_`ªL“Õ̶÷jÆÆ‰Ûý˜ \Šv½Jš™ëÀõWwiLN˜R¶Í§Ä])z™Ÿ±¡SNÛÝì³dÛ²Wì‹mO®¯gžcÉÑħÅäËñM•i6í9ýÖ1…ÿÇÝßôZ³ëèàÜ¿â{2K¢HJl G ГFÁ=è¡ag^£²‘ÎëNÛ…®úõMÆŠXûÝCÞX9Î=÷äÉKß½×b/‡cŠ!ûמ žŠvÝɱ¾ë&Àôñ;N·=‘dw'ôEàj5kMÆdc–ÏÕÝñÞœÊÅ«—IÝIš¾ë&ÀtSùÍ!iRÎyi®Ü1ÊQ7€˜ÃÚø¦£”~v&š+íWPý˜fÅï”­ÖC·´Ê«–iÀ˜Þ@]ì~ÛMŽŠvÝɱ¾ë&Àôñ;N÷üf¢²¾õ©\m0&Ó/ÆT ÞÑì«‘wÝIš¾ë&ÀäW~Ç\r²©®œ^%]+ŒIi)¨1€néV{~G}„ôÖM$‡Ó¬ø­¹%£þ‹ñ蟖µi4»0ÓUÇTô³¹“ NE»‰îäXßu`zŽø§Åï’¢m;˜ì€ÿ'0Õ¦c²{¶cʉnÄo¸í:z›4×=€ üÊïÈíκ͇£Å+)ÖÁRYȆ ,ß•Ó} Šþñ%;Aý˜`ZüVç¨èÖ+Tý˜Ó€1!‡ëTN׫»’¸í:º“c}×=€ ž#~Ãtå·°„d­!USc0¦”Ï*eeL9dÿ/ÀUÎ]Gw’¦ïº 0ù•ßᨾbÝ{$È‹Œ (€.à1–Õ–º}d$ Yô¯OX´ø­»$@<>ŽªŽ©1“~6cRì¿Ñ˜àR´ëèNŽõ]7¦çˆß0=ð2è[ Y·Ö?÷ÿ­iÀ˜ôUxkL”än5»¦XÖѤé»nL~åw°k4C(kSRlà%to¡áÓcÝòSÞÓ«üþcÀ4]ùmkV‰¶¹¬‡4¦c pu pÓ¾à*箣;9Öwݘž#~ôø­ï{B”$T[¹ÆÔ_ͲD~3&Dº¿áR´ëèNÒô]7&·òÛºh0e±™“1,‰ßFz [sXÊÚ0û“•`¢r%V¦öÑr˜¿™‚•ŒŠ]-ªÄïÚ4š]X^Ówl¼ª!¼»í:º“c}×M€é9â7ÌŠßX÷ I—ö€Õ]¹ÆÔ_Ͳ2›|1&;ºIšSÑn¢;IÓwݘÜÊoÈ9¡:Øfl ?SÒ9Z%=CdYdLYß0&e#}°ÓùõŒs,#AH%¤€6ûó§ÆT›FÓž¿d¦ wÀt*ÚMt'Çú®›ÓsÄo˜¿uå1QYš))iÀ˜ ~kLé%o8I“ÞŠv½MšëÀ”ÜÊo`»6BxæbHŘ0™B¹ˆBÌâ©(¤a )G OnåÒ¬øÍÄ%XëóÈ¥¾’R›F“xJº:Xä”ðF.H§¢ÝDwr¬ïº0¥çˆßiVüædWªõ*TªÊïÆ4`L9Åoc²Ž7Is*ÚMt'iú®›“[ù­ÐZ1…€…‡eŽcb}Rt7g—RÒ*cBÝï°‘t!Ž ~L³âw)бJvõ'’êJJcÍ.Äøž]ä®çW:í&º“c}×M€é9âwš¿í‹Ý‚Oõ$ÞÚ4`L–t0&xuà÷’æR´ëèNÒô]7&·òBP,ˆÖKz‘1 eåJ‰D„óbK@ …ò,ʺh|æ7À4)~ýÖJÐw?Q¨ŵ¦ñìÂë®\ñ®µN¢/?º“c}×M€é9âwš¿55‹•÷c3‰·1 Szõ%;SÛ¤9í&º“4}×M€É­ü¶™nÁø’ò=J‹mOô÷%Ô­…î[$¯V~C²`>.Ùbù¤Æ”f{~‡£×¦BRËiĘ”Ò¼âM¹@:y7Ñë»nLÏ¿Ó|Ïo}¬@¹¦Æ4`LA¿Õ“1%q}“4ïFÞUt'iú®›“[ùm£bÒXÐÜX驺 PŒ%Ûã”VOåè¦:YsÈðÉÖºiVü–œ$Úà–H±Ò˜Óˆ1!È›1½ê0¼;í&º“c}×M€é9âwš¿A“ßFQ s]ùݘú«ëWNÆd×0n€ ×½MšëÀ„nå7Øý¾DwrúQ,v@Î!ƒõÆ5|©ÀÒþdV/H ?ÛGN‹ßÖüÜfU[®~Šßµi¨1!ÿ¡1Ýè˜x)Úut'Çú®{>GüÆYñ[ Ø4²ÍR5Z§1õW3&L|1&¾½Ç„§¢ÝDw’¦ïº 0¹•ßDa%EýH ŒËkÆ”8Ùo+¥HZ*°´?™K´Q™ú™Mô5ø 0ÍŠß ÑÙ~*ÑÿS_â­M£Ù….ÉîÜ0&<í&º“c}×M€é9â7NŠß¹$›‹œ%¤ToMÆÄò®üNáææ7â—ÝIš¾ë&ÀäV~G«»Fۉƴ8ðIlˆ/€n_‘ïÊ)Ë¢Œ9Eá𢭦ÙÊo+D³$¢;¦ªÀ²1ffzÏ.d;`:˹›èNŽõ]7¦çˆß8Ýó[÷™ƒ¾ñºZüdLiÀ˜ ¼+¿¹cLW#ï:º“4}×M€É­ü>æŘ Ú"±Xù#)áÊdçs‹wåôÕµ=µd±S½OžÊálå7fe¾‘Ku%¥1“:_Œ‰Þ” àYÎÝDwr¬ïº 0=GüÆYñÛŽ³!Ç ‘°êÇÔ˜ŒÉ.Ô_Œ S¹)°ÄòåGw’¦ïº 0¹•ßú“ê^,(é),y±Ž Q¹€u-a¦´Ú] w‡ùhdIù“—xqºç7eÝXVêªáiĘ୹1Þ– àÕÈ»ŽîäXßu`zŽøó•ßÄ^CcëñMµiÀ˜¸Ó}K z—sWÑÛ¤¸îLäV~G›‘ž1(y±ÝÜ"cBP¶¡¡Ph‘1U1ë‡e Ê'OåhZüìäâ58þ'0Õ¦c xÝ•cýEo]ŠvÝɱ¾ëÀDÏ¿iVü¶â#Íÿ°nIÑšú«IÌïS9»¶§t*ÚMt'iú®›“[ùuí…mC¦?ó0Ù…»Á!Æβ‹ÆRV\³kÀ)Œ!ñ7À4Ýö$Ý›&}ù­ýù϶'µi4í¹Ä7cŠ·uLtõ2©£;9Öwݘž#~Ólå7KJú·=Q­f­©¿š‘UX^Œ) Ü1¦³œ»‰î$Mßu`r+¿ Z‡¥zh0±pÝí`Lú¨nZÚLGY¬c*Q_­¬1¯.Ã#½ßÓ¬øÉ:èßÌ505¦Ñ´g¤÷´gItL§¢ÝDwr¬ïº 0=Gü¦Yñ›­F¥@2…è'0Õ¦c*Ìo ˜n4&:í&º“4}×M€É­ü&AÑ¿•FòŠLt0¦cv\,ÕíàÒ%^ý“õ“·öë™ …8¼h÷`š¿ I 6_¯©O~kÓ`va¾:Xe¾Ñ˜(ùÑë»nLÏ¿iºíI ÁZ²¾FcjL#Æ”)_Œ âÝKºz™ÔѤé»nL~Ïo‰Q1¥€nªîá¾ÓÑà<Û&Y­ü¶‹ÃÖ,ŽÑ8ÍpÄÊo€iZüFeŽ™uÝÒ´¨4¦Ú4˜]ÈéÝWžï*¿éR´ëèNŽõ]7¦çˆß4+~³Í6eÒC®¯¤4¦cʯ»rÉêAü¤áSÑn¢·I3pݘحü¶–ˆÅê$Y Ö"c²­\±*d8V4&d¥kÖ]7CÌŸdL<+~ç,xô§ÂÜ´Ö­M£iÏáür0&;¨½É±SÑn¢;9Öwݘø9â7ÏŠßYá$d»lJPµ=iL#Æð[câ»)©|*ÚMt'iú®›“ßö‘‚5E²=ÙÂÌÊcR\R¾EŠm yq+‡¢ï—UQe)%ŒþäßÓ¬ø-9’¤B®¶riÐW^©`¼S;ÆÄéËîäXßu`zŽøÍ³â7$ë´˜¬ŒVª¶'iÀ˜” ó›1¥»£\>í&º“4}×M€É¿£XS\ÅÒ=--ÔH¾ê˜H_»½•ൾp%å8ÀŒÄ`Í}?¹•ãYñ‹$}íEѲxÙ˜Œ)pxO{ŽPnŠxùT´›èNŽõ]7¦çˆß<Ýö$FvsÑVÚŸÀÔ˜Œ‰8¿ë˜B‘;`ºz™ÔѤé»nL7/^oåU—¶rVÇd×p²`àêø&Ò?VÿÜVŸ¦YñRFëXk½È«îi4íYðÝ%U2Ý\çSÑn¢;9Öwݘž#~ó¤øÙ&i±.ðê{LiĘà=W.Ù8„›¤)_~t'iú®›“+~Ûô€œsH‚+5’¯îF— P"ŦÅÖºú¾ê÷ `º¹„áŸü`šx™%eÐO‚3UŒ©1¦=çøž]¨¿åÝVîšbYGwr¬ïº 0=GüæYñ»DF¶)CUÛÓÖ4`LÀp1&еþ¦Ž)ŸŠv½MšëÀ”]ñÛ4¢CcJÖe`µŽ‰c°kîÊIlöc²ùʸC‰2¦[¿¦<=ðÒ.í)@Çsu%¥1 …‚c*!ß°ò|M±¬£;9ÖwݘòsÄï<)~çRt‰@L65¶JšÆ4`L‰ËUÇ’ïFëdøò£;IÓwݘܶ'ÙÎmì´þãªÆ”Ñ*·r´Õ{µµnQLËú™éž§”0„ÄßÓtå7éÛ®,9`]ù]›FÓž_§½¯iÏr×ö$_åÜut'Çú®›ÓsÄï<+~'kúcMØrM³[Ó€1Å×þìÉMÒà—ÝIš¾ë&Àä¶=…f݈éöÖê}V5¦ºx‹è;¢ûÀÅa³´òΠʰ/ïo€iZüIÿædljÆT›FÓžåÍÊmÖÃ0]ŠvÝɱ¾ë&Àôñ;ÏŠßA“8IåÈâÀÔ˜Œ)|ŸNCy4ó’æT´›èNÒô]7&¿íI J]m3÷Úá®Ü•+ !XÿË).XƈdµßDòÑ))yºíIˆE·§…­€ÿ'05¦c‚Bשr¾x‘¯^&ut'Çú®›ÓsÄï<[ùÍœ9¢Xg²TõcjLýÕLW÷xõüVÆ–î4¦³œ»‰î$Mßu`òÛž€Íÿ \Ž KÃì•£(G»ïdãf ,S´Þ—PløÓL³â·1G÷I—— ˜jÓhÚsúfLxw:9v*ÚMt'Çú®›ÓsÄï<Ýö$‰µ¢)6´bL©¿š¡äwU®Òü»^9%|ùÑÛ¤¸îLÅo{‚¬ïvÐÿCyuJŠn[•+>N²Ü(­„Ê.¸ŠDødw2]ùÍŠ!‘nm+©6f2½5&›šs“cW9wÝɱ¾ëÀTž#~—é¶'º…•çÐhL•iÀ˜ ‡7cârwó»\½LêèNÒô]7&¿í “î=£âK‰‹så0† (iʲ8¾)*S!›n½Ï> L³â7'ŠºPA&›û³$¥6fJxÏ.LçŒ9'ÇNE»‰îäXßu`zŽø]¦ÅoÝo€¾>1D®ÅÕ¦cÊ%^w/@·ê7WRÊ¥h×Ѥé»nL~åw‰È ‡4ì¼]W~Ä(Q7ƒ%¯Xwžu-F—Hâp8ùo€iVü>ZSå2* ¬€©6 exO{¾;`)§¢ÝDwr¬ïº 0=Gü.Ó=¿mA·iÖbYü˜jÓ€1)KºîÊÙ0Ø©\¼ëèNÒô]7&·ò;Ú$ÝhóÝRÄñ¬’Š1é“EaElR_o×Ã$ƒÝ“G”ÓôÀËLÖͳèUªaiÀ˜l—{1¦(·[¹kŠeÝɱ¾ë&Àôñ»L÷üŽºgHúÂÛû3iÓ€1á«®ä5§:ËÍ©\¹y×Ѥé»nLþÀK+Ô‹xGXgLÑZ* Ä•Zƒã£6F+&…4BúèVnVü¶3øHlíbu‰·1 ¾.¾S¸¿Ë©h7Ñë»nLÏ¿Ëtå7èú*LÖí°jטŒ ¯¹r LwÃä*箣·I3pݘĭü†hÍ”DÂ1zc‘1(ßIE€ìbéc‚(!Š2€¬ï÷IfÅo%ŒP'JÕ]¹Æ4šöŒrU~'¡;Iâ—Ýɱ¾ëÀ$Ï¿eVü&+´ÉÈÖ ¶bLiÀ˜ˆËubóÆ$§¢ÝDw’¦ïº 0¹•ßú(qaʉdi|“ɺ! °èNÐná,2&]óS ºô'dŽÚü 0MŠß޹Ķ÷³IV?;XÔ¦Á$›˜sÝÇ,Ê'or,}ùÑë»nLÏ¿eºí‰upµþÑ.”üLšÚ4bLáÝÁÒZnÜÓÕˤŽî$Mßu`r+¿Á¤äôÝ K[9;•³9zE’#­Žo¤(¶òë?8}˜fÅo‰Æ!Yo¹Ÿ%)­i0‰ÇªÙߌ èFÇ”SÑn¢;9Öwݘž#~ˬømgÊt4Ø`ªF„7¦c‚T®›ßRº¹. §¢ÝDw’¦ïº 0¹•ß@ìa¤ó®ÜRI°³5¶QŸ‹ã›€ìÔ[!ÑäÜðÉK™­üÖ=R±™ñÅÆÝU§rµiĘ^‚÷‹1ñÝí9˹›èNŽõ]7¦çˆß2]ù1a.ºyÏ¡ê.ИŒÉFZ_Œ)ÁÝh¹Ê¹ëèNÒô]7&·ò[áA¡”l˜ÎÏ{œ4%ˆÓÒíz&¬„ÉÆ4`LñÕÉõX¶­þMÒœŠvÝIš¾ë&Àä÷üÎÖ: ±MÂC]Ǥÿ d÷ì(¯#€¢ä²€‘L]*>¸•;¿žqŽe£Ž)Û¡*”º»@m0&’‹1éÿã— ¤p–s7Ñë»nL¿ÏÏ{œ4%I}st»SŘÓ€1…‚ï»r€Éßÿ§p•s×Ѥé»nLnå7f¥mG†eŽcŠŠÂ…RŒœ¥,Þ•q«S`æBùƒuLç×3αL,Ö‰%Ú8‰º»@m0¦”¾OåotÌèËîäXßu`zŒø}~Þã¤)¤oçte†Zü®MÆè=‰W—ê›—)\ŠvÝIš¾ë&ÀäV~+?ïqÒÝWë®+Y cª» Ô¦þj–ô-zkLošx¥xõ2©£·I3pݘ¢[ù­o-1äŒ kmOô“Ì!b¶+‚J|p±»@ŠvK±ŽŒôI)N÷üf`;º8n;ÖSe0¦ðª½8~Ñ”ï¶rñjä]Gwr¬ïº0Åçˆßq¾íI J_I÷1TÀT›Œ©½{~Çts‰Wé÷—ÝIš¾ë&ÀäV~'Û$(b k—xm“‚X ØlñV5&¥húQ™@eeÃÒÎßÓtå7[ç´9Ü\åXctIUùfLg7K/Ç®rî:º“c}×M€é9âwœ¿s´ÖõY*ñ»1 Så]Ǥ;™›£Üx*ÚMt'iú®›“[ù¢~º gÝÓ•ñÅŠ1‘]'‰Æ£á*Æ€TŒ¬‰õú$0M·=)6áÝJRiê˜*Ó ¯|áò®c‚ 7,ñêeRGwr¬ïº 0=Gü޳â·nÂAýEJ}©6 “âÇ»ò;¤›K¼)žŠvÝIš¾ë&ÀäV~ëâk£å”½$J²XǤ`Fú¤èßQâb“®b l$A«[¿¦iñ;ˆuÉYt'V‰ßµiÀ˜¬ ã͘ø×žtUøò£;9Öwݘž#~ÇÙ—¢++D.X÷cnLÆÄ¯JÂWS ï’æœbÙDw’¦ïº 0¹•ߊI 6 /2&}’õ—6ÅC‰Óâ\¹„Y7½Öš€Ã«÷ÌÇ€iºçw {ñ¨o}ÝÁ²1Ó5ðò`LáŽ1]¼ëèNŽõ]7¦çˆßqVü†RìÎ êým0¦?f~ÙÐMñœŠv½MšëÀnåwÂ’KV⣟I‚%`²êÌœƒMæ“(/Þ•Kº L%Ù"LiØ×àÀ³â·n“¬äתª¡>•«M#ÆÄ ÞŒ)”`‚øåGwr¬ïº0ÁsÄo˜¿M‹°{O,ÍnMÆ„ßSRcá»:&¸í:º“4}×M€É­ü¶™rºGÎxÜà¶bLD¥˜Ú1-öcJ HY?6.=•ƒéžßV´o]þl<`LµiÀ˜lhÞŘt·ëOâÕMÞ—Ýɱ¾ë&ÀôñfÅo»ëIv¡+EÕZ·1 “n_®Êïhw"n’æT´›èNÒô]7&·ò[áÁt"+)‚ÀKWRì 4[˜ù—¼:%%Y§œI·ÖøI ¦Ûž(ˆ°Mï,Uec0&Jïû˜Iwªw9võ2©£;9Öwݘž#~äø%Ù@ëuȱº.ИŒ (^«™nÕóM ð—ÝIš¾ë&ÀäV~';.! IZeLé5»I9bÊaUc*6%%0ëÆà£[¹YñÛ~‰pTÇüY+ךFŒ ù]ÇÓíVîT´›èNŽõ]7¦çˆß0[ùMºµÖCÑ4®ú1·¦cŠ„×$Þ˜!Ý­fåËî$Mßu`ò+¿s‰Ö‹© †°6ðÒÊSu'xÔÕ0¼4•ÆTÐPѪ˜Øj?LÓ•ßP!'+àÿ©c¶¦cJï"wµrp•s×Ñë»nLÏ¿aºí êß)šX[måjÓ€1Y³Õ7c rSù®^&uô6i®{Sò+¿mì†ÝVdX+°£}IÈH“rżª1•ÀÚW¡—ùdSš¿MÖ}2×Sm0& ·Ž©k¸Ë±KÑ®£;9ÖwݘÒsÄï4+~C¶…]WX}û«áiÀ˜‹®ÊïÈÖnËOšSÑn¢;IÓwݘüÊï‚d4†ÅK¼vt@¢Ú8a^*° 9Yç¼ê€¥1 z~Ô_Œ)ß/~W9wÝɱ¾ë&Àôñ;M÷ü.bwM‰¡îù]›ú«™ÍVzŸÊQ曓t5ò®£;IÓwݘüÊïLV€­‰žҪƔläSbJYx­\à84q*CàONâ=¿žqŽé6 ˜5B³•«Lƒž_Jß,8ßÝÇLòåGwr¬ïº 0=GüN³âw´žA™õMª4¦Æ4`L¥|ŸÊQŽ7À„§¢ÝDo“fàº0¡_ùY·¶6Ý­¿À"c º Œ„EÑ©¬7Æ”¬=Œa*øI`ÂYñ[Q2[a‡JünLÆT®aÖÜœos,~ùÑë»îLøñ§Åo8 »ÿPOâmLƤŽWËxŽ ÷’æR´ëèNÒô]7&¿ò;—€Y©¦ñµŸIc=»ØüÐL1]E«SIcŒ‰ôåÊpL¶ËyñÛŽáõ‡a¬+¿Óˆ1% oÆt›coE»ŠîäXßu`zŽø³â·KçPto Õ%ÞÖ4`LLï¹òOmÄIüò£;IÓwݘn*¿KÈ…sR—E SŒ‘(ˆþÎßSA&“F©e°QHºú‡a'¨ßÓtÛ°!;ì¯.ñ6¦cÊVet1¦p7Œ¯^&ut'Çú®›ÓsÄoœ¿cÔ)õ×Uº:•kLÆÄPä͘R¸Ùÿã©h7Ѥé»nL~å·S)ŒºÅ„«SR¬ggJú[_Ñp1e‚’D¬éøë2ÙÇ€iRü.Á¶[©„X-~iÀ˜˜ñ]ÇD¯æ ^޽í6º“c}×M€é9â7N÷ü”Ì6 Q¤jטŒ 3¿5&ýîÓÕÈ»Žî$Mßu`º©üfk·ŠØ9Òc²Ë=&÷+뉹PZeLA±P %~´\§+¿meQx.U­\k0&–ðîùE’n.ŠãUÎ]Gwr¬ïº 0=GüÆYñÛjÊR¶æ÷PÖiMƤ‡«ƒ¥uª¿YÍèT´›èmÒ \÷&ò+¿•)¡•úX϶1<üÜÊYgkRxÔ…<¢Ædj‰þX­‹è'Ç7Ѭø­?’þF!‚’ßêJJc0&Ä÷íkÔyS’BñËîäXßu`¢çˆß4-~“5ÔÖu™t1ªSm1&ߌ)å›â7ºí:º“4}×M€É¯ü&›Ô„#fwÞþ™4 G…„È® ®2&¶FEv.GÑÆð}˜¦Åoeoº ví£¿kÓ€1¥˜/”ÞÜ. KÑ®£;9Öwݘž#~Ó¬ø Å:~hF„7¦cRJsUåÚµ¹;`Â/?º“4}×M€É¯üVžÄ¦¤Ú<\Zx©;W*6ç‚ÕA-2&»¡—­¿Ðg[ëÒ´øéG¥ÿźçwm0&£ÎcÒßôæTŽ.E»ŽîäXßu`zŽøM³â7JÑ&^ØÐןÀÔ˜Œ)Å|½D¨ÜÜc¢SÑn¢;IÓwݘüÊï¤NÆ[bk§ráïE0ýY£–EÆ„¬lõ¨‚RÆõÉ:&š­üÎ%3ç$!H¬Sm0&ku1&(åŽ1åÜMt'Çú®›ÓsÄošn{­5%(ÖAég¹@m0&+}3&»¤¹z™ÔѤé»nL~å·õC´Æ#EMʼnX1’ ¿›ïO%õëK lç«ûß$Ÿì.@Ó=¿³¾÷!SÝ‹ÿ¦Æ4šöÌñ]ù éîTŽ®FÞut'Çú®›ÓsÄošxÉ1]„·£ ŸÀÔ˜Œ ^w—^Œ)Þ]IákŠe½MšëÀÄ~åw Ù$l›1`©ò[S±œþÒÊœ` ˜ìO.‰¢Ýß%(á“–<]ù]ô÷@œ¥î`Y›FÓž9½+¿uź9•㫜»ŽîäXßu`âçˆß<+~sÄ”#;ë¯jLÓ€1YÛÅ‹1EÎ7'&|*ÚMt'iú®›“[ù šèL÷.)ñªÆ¤LÇú°¡îéJäEÆ(Ø ÄOžÊñ¬ø-Ö÷.b°ú¬jAcN{ŽïS¹ˆr#púò£;9Öwݘž#~ótåwÑÅÚà¶Š15¦c²S‹1ÅÛ¹r|•s×Ѥé»nLnå7Û@Œv-dmoø{›ŸG!ëípnñT$q.I¬÷åÄà¨ßÓ¬ø]Xt¡RB¢»ýz®\mM{NL{Žw•ßL_~t'Çú®›ÓsÄož¿™¹ØWb]ÉêîµiÀ˜Ê{JJŒw,øT´›èNÒô]7&·òrÔ-U@Ð:•ÅFqÅÆÁÛ´* ŒkŒI±,’ ŽBýÜ>:Wާ{~§¬Ü/ƒý£ÚÊ5¦Ñ´ç$ßÓžéNüæ«‘wÝɱ¾ë&Àôñ›§Ûž(±kUºç¨5¦Æ4bLÞwå"Üoæ«—IÝIš¾ë&ÀäV~JDŒ™ÀVáÅK¼&1q¶­J>‡:®0&R8²S‚ˆvòI`š¿“~q¤…„TSc0&"|wIµSÇ›»í:º“c}×M€é9â7ϼÌÖïXt€uem1¦üî•cÀt³ÿÏï)–Uô6i®{Sv+¿Á.„Z»E+X­üÎ`÷•“¾+)¼Z*­0&´"ꆄ"—Onåò¬øMÖì¨pŠ@¹žÄ[›F³ ó÷ìB‰wWRrüò£;9ÖwݘòsÄï<)~g¡dc$ÈÊÕ~ “µiĘ~kL!ވ߾üèNÒô]7&·ò ƒ+ E\lGQq)pl[ÁEÆ à’•Y`|“} ˜¦+¿ugo’W‰~.~­i4í9ã»VN‚Ü\ÏW9wÝɱ¾ë&Àôñ;OW~§¢;(źÀVŒ©6õW³(ÞÝ…›Êï|•s×Ѥé»nLnå·¢tRˆHº¥Ã0¾ò“1A¶)3VëNúìâ]9Ü‹ k~™>©1åYñ;)ùKY÷¶!·Se1&ƒkÚ³ÜMIÉôåGwr¬ïº 0=GüÎÓ=¿•\Ç^ÂTÏ•«MýÕL©u¹ª”£îaîV³«‘wÝIš¾ë&ÀäV~{ƒ­óXi¸¡ªZëJŽ˜l2¬®âe©íÉQ(o[¹¢5©ûdež¿Ñ Z¿C±É?©1 “2šw_ùò*órìT´›èNŽõ]7¦çˆßyVüFMàœ8Z®êT®1 ¿ÞÊåSÑn¢;IÓwݘÜÊïHº™5Ú’”ö¬1¦pt 2²•³mçïÊE²]¯î!u#ÉðÉ»ry¾ò›ÅÎÀ j©2fæøÎ±Œw=¿ò»œ»ŠîäXßu`zŽøgÅoe®º®‡p,Ð?©1ÓwwÁàî®\9í&z›4×=€©¸•ß1)OÒíœUJ¦¼TÇdúuB ).“ýÉE²Mâµi™xYfÅï­—)õ””Ú4šöŒrµŽîf–SÑn¢;9ÖwݘÊsÄï2ßó[tqO6´j©6 SwU®ø§'NÒ¼yWѤé»nLnå·I©T–ÛžP£9£µ–Ñ®À+ˆ‹Õ̘fÅïd*a’ ª¾ò­iĘ’|3&¸xYNE»‰îäXßu`zŽø]¦Åo&Ý_³n­±î.ИŒ)Ëûæ·äW¥L—¢]Gw’¦ïº 0¹•ßm ù1"…ÊÊ&sƒCa{U^£áVSÇ!&¡¾Ãñ£À4Ýö$ƒ•Odý0~ScM{Æo“s¼¿ËÕˤŽîäXßu`zŽø]fÅïDÙÊÖôݯ^6¦cÊ„WU®`Æ;`:í&º“4}×M€É­üÎhí©)뾀ϻ¦ó[9+‹ÐÇÁf‚èžlMc*¦·[ã%˜òo€iºò;ˆÒ¤ÿ·^üZÓ VNÊw_yNùæJJ¹Ê¹ëèNŽõ]7¦çˆße^üÆ‚úÊ+-IÕ%ÞÆ4bLºI¿ò-0½í*º“4}×M€É­ü&Û|ÇbLŒ‹Œ©X#VÒe;ß}Ô'“†‹òKÉH€Ž¢ŸÓtÏo£"G¼ÝgþɘjÓhvao‰òíVîjä]Gwr¬ïº 0=Gü.óâ7g{¬[µ•kL#Æ”Þ5&be!>0É[Ñ®¢·I3pݘĭüÆ,A÷qìÊÜcŠÇUÒ”³UhÒ[~2&e•).)•(GÔ§€I¦ÛžD«°v5+oM£iϔߓ"þM¹€\½LêèNŽõ]÷&yŽø-³â·MkG]z4¥bLiÀ˜”\'H¥”£µ®L§¢ÝDw’¦ïº 0ù=¿ ³‰KJ›“õ‘l 0¼Äï…I¼6E;‰õ‰Ë±ðL³â·~ Ö8Oßy õ””Ú4`LÖà͘^å)0ŠvÝɱ¾ë&Àôñ[¦Åo±V‹GÖR‹ßµiÀ˜˵š•"ÇÛèÓ¥h×Ѥé»nL~Ïï ›Y%,%rY–ƒ1å,V/õé´‚jöÑcÈ©¨‡ñÌòI`š¿K´æk‰YHÉÏkLÃiÏü͘B¼©c’—¢ÝFwr¬ïº 0=Gü–iñmâêÊïÆ4`L”áÒCŠ…›r¹í:º“4}×M€É­üÀh÷®„Qÿ%-2&'$pÜH‰kŒÉôr»ßª›yu‚ú0ͼ$°ZS݈q5ð¢1×ÊQ¼»ö$ï)–Ut'Çú®›ÓsÄo™¿umÍ Ë3%ŠUåwc0&]Á®S¹^Wê=`:í&º“4}×M€É¯üNvÁ’µ*§cÜÞc‚È’­q‰î‡9,<ü’E?³¬ÿŒŸ<•“Yñ[÷”’uc«»K¬ÄïÆ4bLÌïI<6žê˜äËîäXßu`zŽø-ÓmOr»!k“Û*`jLÆ„üî”KŽ¾Æ„áêeRGo’fäº0aûÕŒ‰JPÊd£7ÊB¯·£Ž)¡(ë)6Êàœ6»Rù vžtOÂg'µÏÓùõLäXÄ”8 ™½bLiƼ» à݈0 ñËîäXßu `Òò)Àt~ÞIĺ*ë[PÝünMÆ”®{]VÆá˜ÞS,«èNÒô]7&WüÎ% Å8“1—`Ò×tí¶þ˜Hò0Yg°™Ö[Hÿ3œdð`š¿K‘‚nÈ©ºöÔš†Œ ð[cºiߌáR´ëèNŽõ]7¦Çˆßçç=Ne#b7EE÷M£¸Ú4`LvíôbL17<`ºí:º“4}×M€É¿•³PÒœrÀWË•ÊoÅõ Q‰¯ x\,°¾UúçZAjJã+¿¦ÙÊoTž£»ð`%²Õ©\c1¦XÞÝlÎà 0åÜMt'Çú®›ÓcÄïóó'®éúâ ‘©.X¶¦c‚"×þŸoNåôÿò£;IÓwݘnÄo…”DfJaA¿~õcâ$EY“nVÎQë [9»UÅþÖmÏ ,ϯgœcVŽ•tkÊ`we~Sc0&’tÝÇŒoÊ0¼Ë¹«èNŽõ]7¦Çˆßçç=Nš’‚XßzëµX‰ßµiÀ˜Îö?Gù±œ"¥“4—¢]Gw’¦ïº 0¹â·tV¶CÊqµò[1 •kéÖU×qZ¿uIâÁši|ø`š¿‹õø·rQéŸÀÔ˜Œ %½gê>×ï’ŠáT´›èNŽõ]7¦Çˆßçç=Nšb£MMleÌu?¦Æ4bLú*\Œ‰sº¦x•s×ÑÛ¤¸îLÑ¿uÙdåJ™£î©S ˜5²€PYeLºä§Ö(Œ¯ÿ˜âlåwfÊŒ"”ÄU§rµiĘ^ítN¯–æ0ųœ»‰îäXßu`ŠÏ¿ã¬ø¬«t(šÿ¶þTŒ©2 “òákÿ¯´8Ð 0Á—ÝIš¾ë&Àä¶=Ñg±‚=’ñµš1Ù8f«âw,b-ûÉÊRÇ¥¿¦Yñ»è:iE÷¨õ\¹Ú4bLò›1áÍ%^Œ§¢ÝDwr¬ïº 0=GüŽ“â·Ø½,ÉÖZ´äŸSk0&Ý¢_ûñ81ñ€é¥h·Ñ¤é»nLnÛ,ú#*qŒ)äÅÊo B¥X—9Ë“ñâr”òªxý0ÍŠß Ù5ÙÈu¹@k0¦„ß“xLŠ»¦SÑn¢;9Öwݘž#~ÇYñ;Ú͇P Ø=øŸŒ©1•kÿÏìXb<í&º“4}×M€Ém{B€)PàW§ò%ñÛ^?ÊÖ%N7ÄŽ6KWR2éV®$ëÆðI`š¿•ºå¢{{««®ÄïÆ4`LÀðžÄ î¶r§¢ÝDwr¬ïº 0=GüŽ³â·µ9b»»˜ˆ*©1 S¸î1Qɯ>BNÒœŠvÝIš¾ë&Àä·=aÒ ¨î (ÙÝ”ÕÊo£<˜M\[xø¸Ä«x–¢õ‰S€ânå¦+¿A¤èò’„«iÏ­iÀ˜™è͘âÍ]9ŒW9wÝɱ¾ë&Àôñ;ΊßÈŽ:µ*°lLÆd=:ÎÕŒôôïÊéîäËÞ&ÍÀu`·í +]*ÊY²2¡EÆdM8 èKh¿y^<•ÃÂb7aPˆBø`Û“óëçX¶¡€¢ÌÑŠºª­\c0¦øbI¯º¾ß„p*ÚMt'Çú®{ØÁòüzÆ9fµ‹väƒÄ\‰ßiÀ˜®¼úËqØnÊàjä]Gwr¬ïº 0=Gü†é¶'VHh=\«Õ¬5õW³"ùÐZñP`ã]åwºz™ÔÑÛ¤¸îLÉ­ü.\¬Š¸$ !¥Õ»rºû‹b·¶”x…Å—6! – Š¾ÄŸ¬cJ³â·m”²n.D®z~7¦Ñ´gÎW_ù¸ÜX¦SÑn¢;9ÖwݘÒsÄï4+~d.)Ø4²¦\ 6õW3}Ž))Ƙ0#Æ`:í&º“4}×M€É­ü–„¤?4¦£gë¢øÍ õ´ß;½¦¤, ¼,Á:…GåMi\Aõ`š¿)r¥»vç±:•kL³Ð÷]9eO7Œ)ŠvÝɱ¾ë&Àôñ;ÍŠßCB»ëa5?©1 K~3&¾ߤàõåGw’¦ïº 0¹•ß1$¼R°2&{&ñƒ°õÓ$Ý‘_ó™LejÊÖl:ZQlûdešn{¢«JÎ’’©…?©1 §=ËÕIä¦V.]½LêèNŽõ]7¦çˆßiVü´â2]›rÚ4`LéÕx_U~é.iNE»‰î$Mßu`r+¿cdë–/ ùИ¦É`Ø®ðZ…&a\Ó˜„£mS ŠlòI)M‹ßÑÆìÙ`@†ºÀ²6f–pMI±7µréR´ëèNŽõ]7¦çˆßiVüfý¬ßCÖ«û1Õ¦þj–õ‹¥‹1]Wœ¤9í&º“4}×M€É­üŽÑ®ldåz º![cLd =¢¤’8œeóI#åèÇD„¤ÿüdSš¿ÑF¶ ¤«.©­i4»0æïÙ…ojåÒ¥h×Ñë»nLϿӬølè’ Ûå‰êT®6õW3]̲\Œ)¾¦S;Iƒ§¢ÝDo“fàº0¡[ù#Ù¤Xûô»5ÆDÅD&}Sé®l¡/ïKŽD¬Û8 ¹Ú/€ gÅï D7ƒnnmù˜Óhva¦«|BB¹;ùÅSÑn¢;9Öwݘð9â7ΊߚŠLŽë¢Õ%ÞÊ4`L¹½ïÆó]k]„/?º“4}×M€É­üÖu7¢ êàr,ì Œ‰ÛYä’9$YcLQáŒl¦¬~`tÜÙø0MŠßÅ®í[—?ãŽõÉomÍ. pÝ•+\òÍ ¦/?º“c}×M€é9â7Ί߉SÆœå¨}­Se0&« <“ ¢½F€øåGw’¦ïº 0ù=¿Aa!ŠÝÄ”%`²R$Ó„X·c1/Xu‡b5ßÙ6rG?¦Ó¬øÍÊtƒ1Þè'+oM#Æñ: (š7E¼H_~t'Çú®›ÓsÄoœ¿@9yNv§«šÄÛ˜ú«+9¸*¿SŽwSRðT´›èNÒô]7&·ò;B.ºÿŒIÊq1d…1éŽBß{¸‹•ß1¦d9 Û@,ÝÊM÷ü&LLÁæäIu*טF³ 3\, é~õ&Ç®FÞut'Çú®›ÓsÄoœ¿Ñ®zЗ^׊ ˜jS5ã\$_ŒÉ*"o’æT´›èNÒô]7&à%ýB)q ˜þîï)ë\¢ ¸YY¿_75¬ê‹¢2&þ(0ÍŠßXtw)Öë(”êocM{tmmm‡'È—Ýɱ¾ë&Àôñ§+¿²äÀIYlLiÀ˜”àŘã 0ÑUÎ]Go“fàº0‘[ùáhí£R ãjåôÁL?_*GA4(²)æðÑ­M÷ü†¨ŸÆ1Pª¿Ó€1!竃eL7¬œ®FÞut'Çú®{=Gü¦é¶'YJ–ã0>ä ˜jÓ€1AÉWSJ|ǘèêeRGw’¦ïº 0¹•ßvèœc1á;”µrk³O•X‹óëE\8•Ò=d>¶¾a¨ný˜¦Ûždº±$Ðß«î`Y›FÓžñ]>‘K¼Ctõ2©£;9Öwݘž#~Ó¬øMr̲NÖ¾¾bL©¿šQ.cŠt×Z—NE»‰î$Mßu`ò+¿­ÊÑn_Yoû¼X`jqÔ3᫵îJK±VŒ&äòG/ñÒ´ømóÎ…bФê.ИFŒÉjÿOÆÄTîÓ¥h×Ñë»nLÏ¿iVü¶Ù†ÖDªrS5£ G㡃1Æ›â/?º“4}×M€é¦òKRòbM¿_wü¶rÈ£•WFë7·XÇd}31J´n+i|Kï7À4)~—JP Õ­i}í©6¦=“¼S"¼¹]@ùËîäXßu`zŽøM“âw¶»¦6€4×G¹iÀ˜0a8(Á¹[ÍÊ—ÝIš¾ë&ÀäW~k¼yôŠÃ¸vWÎÔ’•ôDN×tãé¤)”Š®þÇÈKÉŸì.@Ó=¿³$eк±”Ø4Š«LƤp}uI5½úŽ•_¼ëèNŽõ]7¦çˆß4+~ÛpˆHŽ^ìcªMÆB¹º —pSùͧ¢ÝDo“fàº0±[ù-YéëÛžª¡.à”peX™ýt¼¯9CyÕ£†WÙø§€‰'ÅïŽá›ÊvŽ)y?Sm1&ŒábL@áæTŽã—Ýɱ¾ëÀÄÏ¿yºò› +åkf~µ¦þj†\àªcÒœ¡›ª\¾Ê¹ëèNÒô]7&·ò[—ÝfŠ Ýqáœÿ‘¬S) É‹så²í‹(¨¥Dñ“[9žn{"õ‡ ºÕ—ê®\c1&ŠWKk s—cW/“:º“c}×M€é9â7ÏŠß¶C ÙÞ ª»r©¿š¡îÎábLv¹ý&iNE»‰î$Mßu`r+¿ gðvTI–µáVkÀÉú›è"¾Ò0üè`iÅ8Q“]–û(0M‹ßÉ8œälT¾¿kÓˆ1¸rÀ»K¾í:º“c}×M€é9â7O·=)I_L‚©FP›ŒÉni]Œ)Ê0ÉW/“:º“4}×M€É­ü.¶ð&HÀ”e•1%¥Y¬I\ 0í&º“c}×M€é9âwž¿•Û(#Q«ßLŘÓ€1AJWÏÜXæSÑn¢;IÓwݘÜÊïr¨õÉ&QúºÈ˜L‰ÇP•}à‹16…Oq‰twýI`š¿ívls¸ê–µi4í¹ÀuWެëÄMŽ]ŠvÝɱ¾ë&Àôñ;O¼$Ì™S¡l‡G?5¦Ú4˜ù¥$‰.ÆDï’æšbYGw’¦ïº 0¹•ߺ•cP$µ E–EÖͰ¢’ä•"¨ƒ1egGE$ÄW—¹Ó¬ø]²•šb‰1rÕö¤1¦=§÷œ=ÝïÞÝ.ȧ¢ÝDwr¬ïº 0=GüÎÓmO "Û4ik´ñ˜Ó`Jj~Í’;¾N“¼¤¹z™ÔѤé»nLnå· ÙËŠ§%*Ù[dLv÷Fib„X k$«:¦¦mA°žãŸ¦éžßº‡Œ¢|'Ö/kÓˆ1Åc²{J79v5ò®£;9Öwݘž#~çYñ›íFecÿ±>•«MÆ„%\§r1Ýœ˜”ðåGo“fàº0¿òÛXF±[¸eMü6‰—r(ºÏÖMx©ÀòUwb]ü…OžÊ•iñ;…£m»îj¡bLi0íù,Í:¦=+lßX–KÑ®£;9ÖwݘÊsÄï2[ù6‰#s‰ÊGªÊïÆ4`LPðªcÒ*Þ\I)g9wÝIš¾ë&ÀäW~“µ $›\ë˜J¶ö±Há²xWÎdÜlåß(åOnåʬø­%¶’ú»ÄªQ\cêç˜$Àëv…tw%¥œŠvÝɱ¾ë&Àôñ»ÌŠßBfEBŠ05¦cŠñ=W.Z‰îMÒœŠvÝIš¾ë&ÀäV~‹èâŽÇ¹ ´4‰W¹@F Qw®Ób?&݉gbckòYÆ4-~³í‘”Æ\X6¦Ñ´g*×db´q^79v)Úut'Çú®›ÓsÄï2-~—@¢yœkÆÔ˜FSRs¼º ØqõÁžœ¤¹í:º“4}×M€ÉïùІ3&cýª¢Xè.¢2CÅa°VÔ¼ØÁ²ÐÑ =#é×Á¦Yñ›+ªNÊwªFqi0í“\=¿ntÌr*ÚMt'Çú®›ÓsÄï2+~ ›B€úý¦Æ4š`QòÕIB|­lNÒœŠvÝIš¾ë&Àä÷üŽ1á¤fXìÇTJ² g6ïDJ¸:6L%® ˆrŠElŠÃGiºòIáYwJúEV‹_cM{~Õ1½¦=ç£5¨LW9wÝɱ¾ë&Àôñ»LŠßY3Ÿ­ä†ÁÚ¼ÿìÇT›FÝC¸öÿËqÁÒ& _~ô6i®{“¸•ßÑZ´E4޴ĘŽr¶¥©9YÁ|Òo–¦d­Ò‡ ~L2-~³¨2™ŠSŸÊÕ¦cJYä͘¢Üˆßr)Úut'Çú®{“ L³âw.ú£Ø c‰õø¦Æ4`Láu9ü`L6né˜NE»‰îäXßu`zŽø-³â7³m•„ÁšÁVSm¬f…Žk(d¯–î%â 0ŠvÝIš¾ë&Àä÷üN¬,8Y£^œ’ºý#««¡Wdž¥¹rÈÊ•PŽêÎOŽo’YñÛ.#ÇÂQ'[SmM{F¼jå0æ»’9í&º“c}×M€é9â·L¼]]SL‰rþybÒšSR8,è/6€(mO=`º¦XÖѤé»nL~ÏoÔMG*&óhª/Šß™QŽŠíº“[ž+gƒÔ­ÀR @7õý 0ÍŠßd×öK Ö2¸jßܘÓž_ ž1¦áŽ1ŠvÝɱ¾ë&Àôñ[fÅoý"@(§ oŘÓ S‚£lÆ“ÂÜiL§¢ÝDw’¦ïº 0ù=¿Q·žìÒZâ1o©Äo†rˆÙ*ñê$^¥[ô“ýãPvÿ 0ÍV~§’} 6îðçKkM{Îüž]˜u%¼¦³œ»‰îäXßu`zŽø-Ó=¿­/µµqÕ¯¥ê•Ó˜FuL¥àɘbäãþh L®FÞuô&iF®[µ_Ý‹1eÝ~æ£Æ«MõcRެl‡ƒ„—ػĘ lê%ãqÑý“ÿHšóó'M>fCè6S÷îXO¨Mš}NF=FëØOí" …k,eÝIš¾ëÿ©Hóÿþ×:ÿÿþßþÃ_ÿòÿéŸÿzüþwÈÿßõÌë¡ÿå_ÿöÿùëñüåoÿñ/ÿÛ?ýëýoºÄü—ÿúïÿë_ÿËñüþÛ?ÿûý§ÿãÈÜ¿üã?ýëé|%FùÛ?üƒ=xýOÿö¯ÿ—ÿùë/?þúü§?ÿ§ÿYå¿ÿËÖìïõ0ÿø_ÿéßÁ¿ƒ¯¿üûùGs¾þÿóz)^ÿýË_Õ‘ãkë_þòw6È­æ¾WÿõwGNF8žÕKáN»®&$…3¢É!„ź¸v"Â;"äwÄtýŒÀŒIè|þïlŽa)VÄãF|ÅÉrÅFxGÄÓŽI·OñT}_¿µQq~5±÷#]ÿv¾…ðÇçˆSÖÏR¢ó·>JÐÓ!Ä»?£Õ0å3¢bô;âûsBÝjÅëyè žwW¼Ÿ1.×oè1õ÷#yÝ$<#¦$¨Ÿ}¹¾«&¢Ý~ëïˆø—ë{`ëuߟ£ÛvÚÏž×§WÂûß^ð’þø²2Æ?>GÝŒérƒwAÓ ¯ˆg‡ôÇç˜J>:…~ÿÖJ5m)÷¿µ~õ[§?>Gj‡¿ßcÊö?Þ~×öƒÑ1}ÿŒW>š^(˜Â?#cÃù>"Y†¿~ës:8^ŸãßÙ¹«uk>‹{^?#ØE¶ÿ¥Íð¿‹ú©$²ˆúoÊsùñú!†¢ ”¾¿Qè %ý×ÿÒ|3ã™=vjðŽx½×Ê!Ðòåû½Ö>2Øã3vIâü¾#^ùHPt­?Ä¢3ÁÅb¦Î{ߟ£¾×'ˆÿ[]C ùÿ—ýëßýù_øë?þåŸOæñûëüÿôý—ÿªþ¯ûOùûÿéoÿí¿þOÿð¿âßý‡¿ýË?þ½­—ÿîX ÿÝÿñ÷Ο«ý›÷¿Ùb¬Áºÿ·ø‡¿þ—ÿøßþùŸÿ÷co׋ú—üëÿÏ>ÃÓnf¾¦×÷Oöó]¿ÏùÛ¿è¯+Ø¿þõÿûßþú/ÿð¿ÿå?ýíÿú—¿þË¿ÿÿü×<ƒ½´{Åù׿¾–Ðëÿº²þí_ÿ¯çG¬-›èû£ü±ÍÒ%'ý»²÷ºƒ…®üLðãòÄË:ÎR;§ÿÛù ÛëýÃÙÎTßÎÿOý l!þ§ѵ\â‹<þoµß忼èZÔ ¨.J#Ûâr~ºÿ¯ÿúïÿõøh¯§þùoûÏ×÷–útÔÂþ½‡ù?‰žÏ}S_{!g/ ±Ñ…`óQã 2¾/ Õ¦AÇÍw|÷Nk¨©¯‘“/?zM}‡®;ì—þò"›©÷K) ekîeÑh¡Bú(¯>€Ùº¸‘ïâ¸[›³•=ê^ K~­4Ÿr®¯g˜cJE²Ò0‰¡xõÎ1Ç4P˜Á.è½rLWÚciNŽ¿Nt'Çú®;9Lþ ‚?’fòLÞnS(ËEÀP"iM…Y_ÂKд–ówIƒ_~t'iú®›“{&o'_@QJ’ y ˜^e0v«,èÎqóBŽÕlEÈbU¥¡Œ’æ7À4{&ÇýXT"iLƒÛØÉÆ(¿~%Ý$`¸É±ó ½‰îäXßu`zÊ™üõy“¦»o-œ­±ÐO…¹1 S|Óß)0ÅxLçA{ÝIš¾ë&ÀäžÉ fë>kÂ…5Æ$x̪+tœË/^ᇂ6†LùÃ0i~L³gò9Û­ÝO檄¿1 N1 p¸X9(ùɱ󠽉îäXßu`zÊ™üõy“¦`¤"Êý!üìûКýkéuYè`LŽm—4W‹µ:º“4}×M€É?“O6iÞNÕíÚêjÓ#»ábµ0%CZiå–Žžº$a"œé“À4{&¯´12ë²¥|§bLiÀ˜b|3¦W§/Ç΃ö&º“c}×M€é)gò×ç=Nš’rHHÈI9NŘÓ`5+å©1ÅÙ i &¢XiCêŽÿicÊ…µÃQäåØyˬ‰îäXßu`zŽø§çpS²&Â6þ¢¦Ú4ê-’0_ŒÉºÞ$Í5\»Žî$Mßu`rÅo»¬ÊÖFøhŒ²(~áwäÀ³•p¬iLA„“í#&ŒŸ¦YñÛ’AÅæP]áoLƒÓÝi¼“¦ÅÝâG_~t'Çú®›ÓsÄï8}!ͪçÑNKcÝX»1º±C¸n^õí¹Išë–YÝIš¾ë&Àä_H³žE) „Tšö¿æpG°–…V*–i8J»*¯äRÄÚDü$0M"±©hV¹•ƒénlº¦¤‚bÕY?kµ¦c:š@Œ‰ŠÜåØÕb­ŽîäXßu`‚çˆß0Ý ’®%BÆ\ŸÊÕ¦AÓ£˜Nj`µË9ßhLpµX«£;IÓwݘ\ñVtÖtPŽf ŒIf¤,‘ÖÊ‚I}9A;c å“§r0ÝM¿¿D&ßP®Smé˜Âx1&Nxs*W‹µ:º“c}×M€é9â7L‹ßº¬Û"ݽ§ºŽ©6 ’!\§rÖZo’æR´ëèNÒô]7&w Qf$ë]+ÖNv1éà Æú ²„UÆDÇÁRNÊ™®+Ÿ¦iñ[·Iú‹äh}*©6 ÷ÆÄù¸cç娥h×Ñë»nLÏ¿aZüÖeBŽnçP*ÆÔ˜FG¹±\§rÉjüo’æR´ëèNÒô]7&w‰Ýð;TK‚–Äïãá\ЊJ)IZ(‚:“â!GŠ!§OÓtå·njCfý}^?ПŒ©6 ?ëåx1&»Z“cW9wÝɱ¾ë&ÀôñfÅ碌$] cRªS¹Æ4(~ã×À¶ƒ1A’;š}*ÚMt'iú®›“;ŠÄü¥dÝÊIxõÆ^`Lú0J6Š˜(®<|0&»8¬:æ×Óôî Zo:æRmåÓ€1Qx“À£öMŽ]õëèNŽõ]7¦çˆß0+~IœLÉ$¨º±5¦Á•°æE'cÉ7G¹éT´›èmÒ \÷¦äˆß63C E,’r@M÷5Ƥ£õ‚²‡$KåvŸER¢UDyWüäV.ÍŠß„ºO²áASä'05¦‘\€ôî`QnO~Ó©h7Ñë»îLé9âwš¿²ø(…¥¬Õ˜úI“¬ãŘÝiLéT´›èNÒô]7&·í‰èÒ°=Ò2.è×Ç%^›Ü–"†˜$¯Ô¼ÚD*ß*Ö/ÑF¸Á'iºò;Íâ"cŘÓ€1é‡yýJÖÞë¦\ ]åÜut'Çú®›ÓsÄï4-~[í5ÚˆÕŒ¤Æ4h{‚‘ÒجƒÛMÒ\ŠvÝIš¾ë&ÀäV~‹©Ö©€ØHtX¿‡8€> e…n½F‘åâ`{’”>YÇ”¦Åo²þPl½°®ü®MÆ”.ÙÌÊSàNÇL—¢]Gwr¬ïº 0=GüN³âwBküL9Û¾£Ò˜jS?i(ÄxU~'¾)H§¢ÝDw’¦ïº 0ù•ßC¶*SÛË•‹HN%Íñp Gq„ÕÖÀüÃcR0Ó=oÉ1+8}²ò;M‹ßá˜&œ™«S¹Æ4`L@I.ƤúŽ1]ŠvÝɱ¾ë&Àôñ;MW~ëÛÎÅÆV@úÙ(®5õ“†Î&·c²ê㛤¹Ê¹ëèNÒô]7&¿í‰Ívä¤ÔÇ%Éâ¸[}X¬Ás Öºl˜ìa¦úgŠ |²Ž)ÍŠßÊE¢ñTªS¹Æ4š\ZâUÇú[Þ” ¤SÑn¢;9Öwݘž#~§éÊo¢£µ‡¯OåjÓ`ª„]†¸Å»¼Ê¹ëèmÒ \÷&ôÛžDÊ )qҌϫŒÉÎ )ýi ˜Œn–mÅ"&œn{¢èœ•= *)©¶rµiÀ˜Ž‘ʯ_ ‚ěů^&ut'Çú®{>GüÆYñ›râ )Û$ûjªdc ÖÊJ“.ÆDoÅá©h7Ѥé»nLnåw´ :ÑN®ìêÚp„ZŘôaB(¦[bX˜üfI#9DTªÆÊ0KùܸÛëëçXÎÅ ë Fˆ¹ÞÊÕ¦c |v ¶™\@7'¿ø®]Ewr¬ïº 0=GüÆYñ;¥l EJ Àõ]¹Ú4Eðz•)ðÍþñËî$Mßu`r+¿í®Âh¶+ð™—¦J¾ÎV䬬)æáüµŸŒIŽ÷9Å úgÇÆý˜¦ÅoÝT²X‰ÖãnÓ¨ƒEˆoƤ|òæä/E»ŽîäXßu`zŽøÓ•ßdS¾¸Ø R­1Õ¦Áðvwå7S¼¿ñ*箣;IÓwݘÜÊïE‘%rÐmÙâ¸[{X 'J6µcnYÒëx¢›»•’ÇÊùo€iZüŽ|ô­c䪯|kê/~Ö`Y®ž_ÇÁ€Ÿc—¢]Gwr¬ïº 0=GüÆYñ[wêd}ްT–©Ÿ4…8½5¦ wâðT´›èNÒô]7&·òûÕðäP¾mîê"cJö—$LÊˬ\cLº LV#Ÿ‚5tÒ­ßÓtå7ë§@ÙæbŘÓà¢xQBsõüJ!Ý”¤àUÎ]Gwr¬ïº 0=GüÆiñ[÷Ö¬[¥l·á«­\mê'D ¸“5»ö“†.E»ŽÞ&ÍÀu`"·ò;*Ý)%C ÖRiIü>Fý¯µT,Ê=SŒ ÏJOÿ0ÑtÛ,$9ƒÕšÖmOjÓ`ñ‹×É/¤×`/Ç®^&ut'Çú®{=Gü¦éÊoë•XŽÕ'VÝÓ€fgk1}2¦’îŠßè*箣;IÓwݘÜÊï¨Û(»ƒ d¤Ö^ŒéØ3`àÈ‹S¶*… ¸Xù}ù$0͊ߤ+–uùO9P%~7¦\@åò ¸tL§¢ÝDwr¬ïº 0=Gü¦YñÛN[Û|¬’¦5„I„«»`’p LøåGw’¦ïº 0¹•ß1I,RH©–µËãaˆ j`B,,X껫r°©rdçK¦iñ‰.E!ºÔã›jÓ $E€¯Û€)ß” Ð¥h×Ñë»nLÏ¿iVüŽÇë^¬ä¥êÇÜšFG¹…®{L©H¾ÙÿÓ©h7Ѥé»nL~å7ÚP8É¥@4„‡Š1¡©ß¶ŠƒX¬cÊ6bE¡Médª[¿¦Yñ›tG«<c®ê˜Ó $Ŧ ^Œ‰ÒÝ©ŠvÝɱ¾ë&Àôñ›¦Ûždkóo·>^W"Ì•«LÃâ·÷=&++¼¦«—IÝIš¾ë&ÀäW~£õy³‘@”l|ðc²q…­¦4§±Lô3i”Yf]!¢(ª•quæo€iVüFýK™H¦ ©¦Æ4¸ö”ù{v!ÙÌ=?ÇNE»‰îäXßu`zŽøM³â7€U2GŒuSc0&ˆ|Õ˜`Hw,8|ùÑÛ¤¸îLìW~c*6çs¢eÆ¡˜v^¸(H­1&F¥—ÂÖÒ ÒGë˜xZüÖ--`´B†X]âmLƒkOÁ¦ï\Œ©ð câKÑ®£;9Öwݘø9â7O‹ß…íüHôK®†¶¦ÑË.Ædmï€éR´ëèNÒô]7&¿òۀɆ»a(0VzjÆd³*ÅšÌ…Ì të`L±ë]ÉA‰fÞÒû 0M·= V†–l2ÕSmLâAþÖ˜8Ý]{â«—IÝɱ¾ë&Àôñ›ç^}Qâ'05¦QKŠX¾“.×7IóžbYEw’¦ïº 0ù•ßVtÅVꘕ¹,¬Áù°õå-„˜q±ŽIÑ r±«òŸ=•ãYñ;C8êc9†R5ŠkLƒf„ÖÿýbL|[ùÍôåGwr¬ïº 0=Güæé¶'Vìš@)l¬‡4¦Q/»Ä{2¦øºØî%ÍÕˤŽî$Mßu`ò+¿“5´ö³`Mn—O刓£‰Í_\cLIJr.}4ÓGë˜xºòÛºi&Ôýýkfù»r•iЌһç{d?Ç®rî:º“c}×M€é9â7ÏŠßšÄÅfÅŠ.îUecµ=MïS9}/èFüæSÑn¢;IÓwݘüÊoŒQ¡”Ùîñ.ߕӇIlVuâöcÒdfÝÐRüæYñ»èoc”Ô­uZÓ`àgøžöœîz~±|ùÑë»nLÏ¿yVü>6 ¤œ?E©NåÓ€1Ùý͘(ßôÊɧ¢ÝDo“fàº0å›ÊoÁ¬kz VxXíǤYB¡"+µc›”‰GC&äOjLyVüÖm’‚%sÖ_¦™+W™/ô}W~—|W’’ã—Ýɱ¾ëÀ”Ÿ#~çiñ­=4‰‚05¦Ñhxå@€r³•Ë—¢]Gw’¦ïº 0ÝT~Ô#*­jLÉÊýô·¦‚ «S luPŠL˜ñ“uLyºíIR„Ö]8iV´ã›~šF‹_~_j¹½Ä›¯^&ut'Çú®›ÓsÄï<-~Û¤û‰ú"UŒ©6Fëd’‹1òÝjv)Úut'iú®›ÓMå·nâ²ÝÀ²Yß 'þp>l÷ÝŠ(Ù’ºeIc×P‰#kÉ0¾>ü`š¿M $È!¬» 4¦Á]9.EÎiÏ 9Ý}ùÑë»nLÏ¿ó¬øm-ë‰Ä ר¿Óh|3¾çÊë·ÌwŒéT´›èNÒô]7&¿ò;]»Éаa[à|8‰Uoeâµr]("F'뀙?y*—gÅïbï»þ"Öí¨bLi 1Q>‡3€ÐÝÀ‹|*ÚMt'Çú®›ÓsÄï<ÝöDßz0}ÙzDW[¹Ú4`L9¸ÆrS.¯^&ut'iú®›“_ù”PHŠ‘®öcJF¶b¤Äôš/¾Â˜lšœ’ f¥™ãÀ¿¦YñÛ:R4É+æJünLƒr…Ût2¦^7 ¼;í&º“c}×M€é9âwž®üÎ\P×Ùœk©6 S.ðfLXðFü.W9w½MšëÀTüÊoPµvÀðººØÁ²@;ÍKÊWS´áàú’áÄ-½_S™¯üÖßD²u¾k'ñV¦A F¸“¢÷]­\y—sWÑë»îLå9âw™xiõ2  lJ50Õ¦c*‰ß“n×o¶rå=ŲŠî$Mßu`ò+¿4R`Âå:&} M[›ò½Ä˜¬¡~ŒÖû$A Ÿì`YfÅoQrÅŠ)xôÌûLi¨c–w—T%–7· Ê©h7Ñë»nLϿˬø v V)Ĺ¹’R™Œ©ðY`©Œ‰Âø]ðËî$Mßu`ºéùM&ÕÛh×ãŽÃ"c"› ĺ½®XÚ@dÎrÒÅ?¹•+³â7 ³$­çÏ­\m” Dyß²±™ž7WRÊ©h7Ñë»nLÏ¿ËtÏo]„l>&ëòSiLi°š ”wå7åxǘ®FÞut'iú®›ÓMÏoÐÍ¥/¡,ϕӇ³rÄt̆[œ+—XÑÐ:ÔégeCØ>L³â·`l³*ss‰·1 Äï¬X}1&¾cL§¢ÝDwr¬ïº 0=Gü.ÓmO ƒ®Cªë­iÀ˜„Ë[c¢7U¹åêeRGw’¦ïº 0ù•ß#ëþ@l›;µÊ˜tåÖÍp$…—•¡tc" ¨›A)6çï£À4)~—ÀY·]”Xù_µø5¦Á•”dNÆt.S^ŽÉ—Ýɱ¾ë&Àôñ»L‹ß!Ddɯ+‘?†T¦c*ò͘è®WŽ\Šv½MšëÀ$~å7€!H ²mÖS$›G‡ú.NIIúŒîæòqx<”îÀ$Ó/3êV)J ¹îÇÔ˜ú9†ä{ÚsŠw9vM±¬£;9Öwݘä9â·ÌŠßºOׯD¬`¨¦¤4¦ÑuÞ•ßïNåäT´›èNÒô]7&¿ò[¡Å&(ê¯ßÅBñ6œƒIþŶ¯‹ý˜+^&»EÇí~LÓ•ßYtæbPYµ=iLƒ¶'¶¥O{¹¦«œ»ŽîäXßu`zŽø-Ó•ß‘rÅZ°Õ“xÓ`ÿo³.Ætôúð“¿üèNÒô]7&¿ò;Ú…TH7r%-]I9&ë1GbÍy{~' Œlœò¸wæo€iºçw´®º5Í+ñ»1 ÅÆ·ÆDt×(N®FÞut'Çú®›ÓsÄo™®ü.tH…cªSc1¦WíÒ‹1A¼¦«œ»Žî$Mßu`ò+¿#±²…•È‘W“>lW療¬Î•KºÑ­oLvǵ|òTN&Åï R樛L®¿Æ4j­Þ‚‘Â;`Ê_~t'Çú®›ÓsÄo™¿)$ÔWG˜bªîÊ5¦cНDyiL|7W^NE»‰î$Mßu`ò+¿#-(“èFte7öbLh]ñŽ:Iß*ù™4J²ôåµ¶ú©LÌÿ 0M¼,Q™d=ÛSS`Y™Ãì‚Ü{Ús¸›](×Ë:º“c}×M€é9â·L·=Ñ¥Õ®e%<ÍV®2 Äï:&Å_cŠáêeRGo’fäº0Åö«{1&l}ØÅõUÆdí‘’¾+’èÎ3}Íâ ,ϯgœc™Åº$ˆDuËÆ4ßT¾G¦'Ž7wåb¸Ê¹ëèNŽõ]·¦#~ŸŸ÷8iŠ û IWW}ç^°lMÆYÞý˜rd_˜ŒáR´ëèNÒô]7&¿ò;&`WR$–ÕS¹¬:Ó*K‹¬t™;SNv…uí×ÝÉÓùõŒs,c¶1V”Qr5ð¢5 ^"„·ÆÄù¦$%†SÑn¢;9Öwݘ#~ŸŸ÷8iJ²C#k.]êñMµiÀ˜ÒkåÁ˜r ~e §¢ÝDw’¦ïº 0ù•ß!…Ž$¬V~»‘m/¥ÕI¼@r¸n%õEû`ÓùõŒs,ë×Fº¶"t¬ScêçX.òÞÚ&åÐw¬üR´ëèNŽõ]7¦Çˆßçç=N»Îu4î³3y®©2 Ó9õýŘrºKš«‘wÝIš¾ë&ÀäW~}íŠî@†å»rA7\’.ÞGûØ5Ƥ›è¬{Á¬¸„郧rç×3Î1kþRlb s¨ËS?Ç ]»SeLùn¯û—Ýɱ¾ë&Àôñûü¼ÇIS¬ ßÊ„#¤j+W›Œ 1½Syõfò’æT´›èNÒô]7&¿ò;P¢ Pý¡‹,Ü*óálϱ¥bL9ë¶šíRʸÔo€izàe²â *¨H%~7¦Awï6æš tÇʯ)–ut'Çú®›ÓcÄïóó'MI Y÷ VŸªëiÔÄ+œ[9eLà†1ÅSÑn¢·I3pݘ¢_ù (ãÑODS~E¿†óaÖ§ è†NV5&›ÀõOþdåùõŒs,S6ê& "WuL©ŸcBx^j6Ætwòcüò£;9ÖwݘâsÄï8+~#YÑ«å²Ò’ŸÀÔ˜Œ‰rÁ‹1IA¿Æ$ÆSÑn¢;IÓwݘÜÊoѵ±„˜sHÇÀË›lð“Ø ‘îTl ¯bïäÃc²*fÖ?;*ÕüdÛ“óëçX¶ÒØd@97,kÓ€1)Ö¿Oåòݵ§¯)–ut'Çú®›ÓsÄï8ÝöXìö"qÝö¤6Fë¤x1&M™|—4W/“:º“4}×M€É­üVlÉV,`›9Y¦ãa)!+OÌB²€jc²ªLEtß›>º•‹³â·µÖ¡Š15¦Á}ÌÀG„£¿Ë]ËOE»‰îäXßu`zŽøgÅo"]YîX–Å? ,kÓ€1±uD{3¦;a2žŠvÝIš¾ë&ÀäV~Kf¥JV* ,9/2¦ÌÖBõ7/ Ò"cÒMtënÅ™Ÿ¿ãôÀËh7¦òÚ|ýyW®6 :XD×ìÂTr¸Ë±kŠeÝɱ¾ë&Àôñ;N·=£×aF«~©4¦Ú4ê•xõü¦£ ‘Ÿ4W/“:º“4}×M€É­ü+e`Ëø¥­Üñ°Ý'!ýÍ1¥H Œ)ÚT9+6Nâ=¿žqŽ)í³ÆÈL¯þ?Sm0&C‹1)¿¹9`‰§¢ÝDwr¬ïº 0=GüŽÓ•ßA¿"¤±š’Ò˜Œé<¾µŸ‘‚.Ù~ÒÀUÎ]Go“fàº0[ù­Ø‚Ö R±“žEÆdƒ0%¥Ð®…Ÿ¦é¶'Ç}"ˆ1ÕmOjÓhÚsÈ—Ž‰ÖÙå&Ç®^&ut'Çú®›ÓsÄï4+~«-FIˆDU¹@cžÊ¥«*×nTÜìÿÓ©h7Ѥé»nL~Ïoýùé(%bëq¿Ì˜‚Í«f+_±r0&&+žÊÊ·Æ} ~LómOÊ´úI@}%¥6 SÆïãï¿w/“*º“c}×M€é9âwš­ü¶ÕÕººE,¹ªünLÃ:&¾ªr‘o[R¤³œ»‰î$Mßu`ò{~»Å›°²Ÿqçíš1ÛŽ‘èûRx±»@d¥˜ÖüÙr4Ýö$GÉ6ÉJwû•ÆÔ˜FÓžCøÎ±r׌0]½LêèNŽõ]7¦çˆßiºíIÑÍF@±µ¢ê.ИFŒ)OâµK7Isõ2©£;IÓwݘüÊï"VÉŠÑeµŽ©ˆÓѺÌ4ÅS9²¡r˜1# ®ü˜¦{~ QáXô硟%)­iÀ˜JâwÏ/¾-°LW#ï:º“c}×M€é9âwš­üæd³¤mƾ ?©1O実ÑîDÜ“x–s7ÑÛ¤¸îLèW~+ÝIrüÔ6.}ñTŽ$éÃ&ÅæWOåPb°+ºéaùdN¼ Jÿl\:åºçwc1¦TÞ:&‡»žßxM±¬£;9Öwݘð9â7ÎW~ L¹bLiTÇD ïÕìÕÿÛKšw9wÝIš¾ë&ÀäW~cQ`‘t(M´P¼ ¯‡åIX9âVêÇ•c<䘊ß8=ð2L—¬¤7ÕuLµiĘ2~kLáf¨jÄkŠeÝɱ¾ë&Àôñ§^f0½¯èrQÏ•oLÆ$¯q:¯žß¡ÜlåðšbYGw’¦ïº 0ù•ß)êϪØ"úúÄ¥Ëãaë­k-ò€“r­‹Ø8¢‰.s¿¦éÊoÝã XIåJcjL#Æ$üfå6dî&Ç®rî:º“c}×M€é9â7ΊßQL_eL6ˆ¤Ò˜jÓ€1 ÒwÏïtWc‚§¢ÝDw’¦ïº 0ù•߉ ˜m7× ,‡uÏj‚,¢n_SbDÈÖ/ü“ý˜paà%¥ãŸ1T÷1Ó€1 á{ñÉ›ûžbù3º“c}×M€é9â7Ίߢ».›~HWØŸIÓ˜†Œ)}Ï•ƒÛÕìT´›èNÒô]7&¿ò;ÚO¸þµ¬1Ù΂1KàœVèÖ‹1é'g×wƒ†wÿ 0ÍŠßÊFЊØ§S]+W›ŒIˆß· ˆâ0É—Ýɱ¾ë&ÀôñgÅoý—b÷¹jIÑšú«Y2è͘˜oÊ(|ùÑÛ¤¸îLäV~ €ÝÄ5iÌf•-2&P¶¥È6€˜ŽôÆ9*w%A0\ü 0ÑtåwHGRý»ßÔ˜¬<ÄrõcÒÏ&Þˆßt•s×Ñë»îLôñ›fÅ喇ÅÑî±n{Ò˜ú«Y ôÝÁ2¿&ÀyIs*ÚMt'iú®›“ßó;Ô”n60¼ª‰VS°6ŠVæn:Êjwˆ%ë.Äø“ÃhRü.1„”  ßP/~µiÀÊíìì͘$Þ°rJ_~t'Çú®›ÓsÄoš¿9±X àˆUåwc1¦Hï»rÌé¦*—ðËî$Mßu`ò{~[£7«úÑ Ùê©\@4 DEPí`Lº‰ v{8ý>)~Ó¬øÊxá¸c#UkÖ4bLå¼’r0¦tsÀB§¢ÝDwr¬ïº 0=Gü¦Yñ©$Ý^§ÒL°hMÆÿ¨1)AnŠßèT´›èNÒô]7&·ò»ØuõœmäÔÊ<8–¬¨DÖ¿lUcŠº{, å6b|<-ó7À4+~Ç”õ§±Aœu?¦Ö4bLß“xän+w*ÚMt'Çú®›ÓsÄošn{ˆÊD²þ3UIÓ˜Œ)BxŸ˜d w«ÙÕˤŽî$Mßu`r+¿‹Ët¤Ž6UKŒI&V{†¢ëø0ÙE»Bº{ÌQÎá“â7MW~[ÙCÀ3׌©1 “©ÔoÆD%ÜäØUÎ]Gwr¬ïº 0=Gü¦ñ[‚Õñ)”ü¬1iM#Æ„ø­1%¼aLü­hÿŒÞ&ÍÀu`b·ò»”bm9¬UËq·y1•Âʬ’žs^íùm˜#ÛÁ7}˜xVü6ÅÑÆæ†zàec0&€süÊ]ûf>í&º“c}×=€‰Ÿ#~ó¬ølühBMèºÆ¤6“üÁ˜8ÜÓ©h7Ѥé»nLnå·R¬»ƒ˜’UN¬1&…bNA°”µË£5H9ºÄA€OŠß<[ùM¬@ienñUvûç%ÞÚ4`Lú©|×1½&Ày9v–s7Ñë»nLÏ¿yºòôë(!ql®¤T¦cÒ÷à»ò;ÑÍþŸ¯rî:º“4}×M€É­ü.t;+`²EäUÆd}ñ Zëo ²x*'vO>è‰âøáßÓôÀK«¨*œíà«FP™FŒ‰Ë7cJt#ð5ŲŽîäXßu`zŽøÍ³â·µæ°‘¥©4¦Æ4`LÓû®\Žp—4§¢ÝDw’¦ïº 0¹•ß…­ŸRÖØØÏªÆÄQ¨X‡«¼rÑ.eãxüÑÑFñ•¡@õ`šm{ŠÑJoRÉPÝÇlMÆ”€¿ë˜ôsºÉ±³—IÝɱ¾ë&Àôñ›gÅï`µÖ&Úxlµ•«MÆ”@äZÍ Æ»­Ü©h7Ѥé»nLnåw!5Ĥܧ¤²:%E.ÈdWÝ8ÈÒ%^}ØÆe‚îç”OÄqÏ”ßÓ¬øM6&]RlÐ^µ•«MÆ”’|÷cÂtSÇħ¢ÝDwr¬ïº 0=GüæYñÛÊ‹Á®/è«PiLiÀ˜ÒkÁ±š)O¸Iš|*ÚMô6i®{Sv+¿‹MÂ-dçý¢ø°È˜”kÙ¨L²kŒ©P¥Z¶úCo"Lyºò›-­Ï ×§rµiĘÂwK 妈7_åÜut'Çú®{S~ŽøgÅï(v) ­×b5¾©5 ¾Ú¸SRä.iàËî$Mßu`r+¿mˆ®îæ”èA´»¦kŒ ô©ˆÇý «ÛYcL’rb"*2>ü 0ÍŠßE’2^»7XÝ•kL#Æôç]9¼k{’OE»‰îäXßu`zŽøgÅoã°lý{Rš1Õ¦cÂï»rúð0ŠvÝIš¾ë&ÀäV~—rRP‰‘2¬\wƒ×ÃÖ™ E¶9¾‹,‹]'%˜Œ®}˜¦{~£Š/JlÆ7Õ¦cÒýÛ•c(ùŽ•_¼ëèNŽõ]7¦çˆßyVü¶‘¹!Ù[ðªùScªMÆD¯òÇcâ»Êï|*ÚMt'iú®›“_ù \RÔŸYqBùË*cÒýD±È¸v%ÅSL Ó*,ø©ïo€iVüÌ9S,©êùÕšŒ é.©¯y&^ŽŠvÝɱ¾ë&Àôñ;ÏŠßšøº¶‡"ê­\c1&eÁoÆ”îF„çSÑn¢;IÓwݘüÊïDm†0,²ÔöäxôQ¾e•Pí`L©'}Ãh(»ÿ˜¦^ÚÐÜ\"“”z+W›Œ‰Â÷ìBF¸Ë1ùò£;9Öwݘž#~çéžßA·R¬CÇO`jL#é5Žòu*Géf+W®FÞuô6i®{Sñ+¿S”,ŠÏ8-×1)å1$ÎD6k‘1AÉVb‘­ÐòƒÀTfÅïl—•R%Vã›Ó€1é.õžßñ¦À²œŠvÝɱ¾ëÀTž#~—éÊoÖü—£wmª·rµiÀ˜Ôï͘„Â0Y®rî:º“4}×M€É¯ü¦u{ {Ïy c¢£@2è^, ,Þ•³›…‘­/¯ÄˆÃ#½ßÓtÏoý%@qÄfÝT[¹Æ4bL¯V'gÓmŽ]¼ëèNŽõ]7¦çˆßeVüNl ¢9¾&ÁýY`Y›F~ט”×ðK/iNE»‰î$Mßu`ò+¿IÁ¥Ø¤oÝ—•UÆDÇppå<&ð®1¦ˆ™X²µcÊ0¨~L³â7GL¬0MúÒ×#ÂkÓ€1YÑè›1I¹Ñ˜Ê©h7Ñë»nLÏ¿ËôÀKMkåZtɨÆ75¦cÒ7á}*'ána¹¦XÖѤé»nL~å·SÖŸÚÚãjÏo}8Û@óâ””,tl~í"þD3§ßÓ¬ø)Ys»gSªS¹Æ4`LÌ߬<‡»¾òåT´›èNŽõ]7¦çˆßeºí Ä„šcBXêI¼µiÀ˜8÷ʱ¥ç&i®^&ut'iú®›“_ùhŒIÐz#Ò*cB»h‚?„´Ú]àD”² n ú>LÓ=¿õ dÈœÖÝÓˆ1å?NåønO¹y×Ñë»nLϿˬø­;ë he/ÕV®6S÷‰‰àÝVNNE»‰Þ&ÍÀu`¿ò1‚îgu\í`iÀ”Š Z¡•ễ1¡dˆdCÆõ5þä•™n{R”‡ØÀò\iLi4í9¦ðÖ˜ò]¹€\½LêèNŽõ]÷&yŽø-Óâ7¥À©D»#T·=©MÆdÚΟQß ¼9Ê•KÑ®£;IÓwݘüÊoëï£?°Ø½Ðq™c͘t·‘ÕI÷tqá¢ÝÁ˜’©?¡•XŽ/Ãü˜fÅo]¥¢0†TÝ•kL£iÏ$ôc*7µrr*ÚMt'Çú®›ÓsÄo™¿chz×,[Óˆ1 |×1ÉÝþ_.E»Žî$Mßu`ò+¿9FÄlܧÀøl¬î.õ툩`Êû1åÈ¢À&öa1|²ŽIfÅoÛ–Ú<© T[¹Æ4šöœþìùu·•“SÑn¢;9Öwݘž#~ËtÛ“ÀDPy‰TuLiÀ˜ì-|3&†»ÕìêeRGw’¦ïº 0ù•ßI”ãa¦K^¯c’Œ6•Ž3qZìùÍÇ”ëœíóùdå·ÌŠß™%XÛ*ÕsåjÓˆ1ey똜ÂM“œŠvÝɱ¾ë&Àôñ[¦Åït±H(¤>•«MƤ ýuó›Ý]°”KÑ®£;IÓwݘüÊoЧ »¯¾ª1)ߌK‰Ê™S‰I¬î|b¾øo€iºí‰ãÕôúŸÀÔ˜†Œ‰ÿÔ˜îä‚«—IÝɱ¾ë&Àôñ[¦{~SÒ¿Ž¾"õV®1 “õM|3¦Â>0)Qþò£7I3rݘ ýê^uLÊ—ô7°ùpˆ‹“xõáã\-R%ºu0&`]ú•7ËäŠßç×3‘c!g»—Ã$¹xјŒ©”ôÝ%5ÜL{Ö Ù—Ýɱ¾ëÀá1â÷ùyO$ ‚ÝÜÇBÕþ¿5à»*Wð¦Wøò£;IÓwݘn*¿9P1Á^8Œíë:&ŽAé–ĸr¤w0&£ËV.hÅçøÁ¶'ç×3Î1Ý&•cø*¥®+¿kÓ€1 |ŸÊYëÀ›»Ê¹ëèNŽõ]7¦Çˆßçç=N»À@¨›;c®ë˜jÓˆ1Ùœ¢‹1¥è “NE»‰î$Mßu`º©ü¶–Th•–q™1Q°QBŒbcÎÖT¦2Y[ßOÓ¤ø­[q*YÿS@¨Î±Ú4`L’ËûvAæ }ùÑë»nL¿ÏÏ{"iJ8n²Û$ëºíIc1¦ðݹðÍÌ/ÝÝ|ùѤé»nL7•ß A?+uMqUc"»ÉRPå"+ Ã-i”ª%VhËq¢Ôo€iZüŽ1 -SÝÁ²1¦=Cü>•+äkL.E»ŽîäXßu`zŒø}~Þã¤)h7du˳Ô=¿Óˆ1¥tu$+¹Iš«—IÝIš¾ë&ÀäW~+®DÈb%ëa|c­>•+(vI’M‡]dLÀ9ñ1pS×Åïóë™È1+Û›¡ƒ50µ¦AŽŒß³ u/w“còåGwr¬ïº 0=Fü>?ïqÒØ}*c7º2g©rkÓˆ1!¼û1’ñ;†/?z›4×=€)ú•ߊ P¢µ/Ñmõjåw6“ŽÁi˜û1QRD*MžÊüÁ+)ç×3‘c”u+N”(•ôs+ךF“xX®¾ò ù%)Ïrî&º“c}×=€)>Gü޳âwâ ºTØ™DªÄïÆ4ªüÎøîÇœ_5M^ÒÀ—ÝIš¾ë&ÀtSù­¤%[Ûý d¹ò›E_@%\‰—z¦¤W¥F<&ŒS qÜÌé7À4Ýó;áÑ&%…ºQ\mÍ.¤rMâ!kuu“cW#ï:º“c}×M€é9âw\xi½JXÕ˜´¦Áj–sxŸÊåxÓ+â÷˟Ѥé»nL~å·íÂB ÂɲÕ))IJ+KWRŽ}b‚ô5 vVðA`š­ü¶K9ÖÒ4 a¥15¦c*ïI¼ L7uLºýýò£;9Öwݘž#~Çù¶'JHtU'ÀZcjL£Êo]o.ÆTâÍ0ˆï^&Ut'iú®›“[ù­À‘¬Ûþ{~[e¤ÝýµZÉT5&$ÐEß7¤Çÿ˜&ÅoÌIì4€ ºÙ˜FŒ‰á­1 ÊM¹@Ì_~t'Çú®›ÓsÄï8=ð2èšbB’úJJc1&ùž+Ç%Þ1¦kŠeÝIš¾ë&ÀäW~!Jº#w²€-ðz˜Z¿Î&ôëŠ1aŒ‘R.Æí~Ló=¿“MÍÑŸ©^üZÓ¨¯||ßǤh=‹ý{7ò®¢;9Öwݘž#~ÇYñ[ôegë/¬mÐϛߵi¤1~3&››ß§¢ÝDo“fàº0_ù$P´AL«§rú0[g<Î¬Ëø"cR’%°u'Ÿœ+w~=9–2’µ:z¨øó€¥6 'ñ¼ßº™]p5ò®£;9Öwݘà9â7LŠßº°JæÇ]¡ ˜Ó¨»ð[cBˆ7û€/?º“4}×M€É¯üdz½±Hµ­œ=ÌŠ(Îëÿ‰‹“xõO Ê%1”¶=9¿ž‰³Bve¬åÑÏkLÃ{Ï.TVˆw‹ß©h7Ñë»nLÏ¿aVüV.‚ÁÚK§—¬øÇV®1V3Ý\Œ)Å»{Lp*ÚMt'iú®›“[ùQDtŠñ¨ß^Ô˜¬ ,ƒ Ø/žÊ&•¤@ÊÌ&ò7À4+~#ÅPŠr’T7Š«M£I<Ì×]9}òfà¥RÕ/?º“c}×M€é9â7L¼TÎÏA„ C}Á²64&úî•c²íMÒ\S,ëèNÒô]7&·ò[7žLtKP‡¼N¬» ã>+•%MJúÁ•X8käñI`š­üf+­²ƒÆsvΟÃjÓHcÊù:¦; Îrî&º“c}×M€é9â7L·=»¾¨k–æ®\miLñ]c‚ˆw5&põ2©£;IÓwݘÜÊo" ¨°0ÙÐ5Ædg]Á×ÅÙu2}¹lí§¨ÀøÉ»r0Ýö„•@PæêrÆ4bLY¾{~Q¼¹]W/“:º“c}×M€é9â7L¼,ºíÊúÚÛ¿þ¦Æ4bLX¾5&º+°L×Ë:z›4×=€)¹•ß\H_"»QrŽ‹•ßö°n[!¢õ°\œ+L£‚¡Q®1$þ˜Ò¬ø-¨;q}ñK3†¾5 r,Iþ¾)w‹_Š_~t'Çú®{SzŽøf+¿¬™”L¯¶[2¦Ú4bLåÝÁ­YÎMÒœåÜMt'iú®›“[ùÍúGÝìXxKÐ?“=¬€¤à” žæÈŠ’æ„ã‡LÓâ7è¶²XaU05¦¡ÆT¾ë˜øî>fºí:º“c}×M€é9âwšîùMǨ b6êžßµitW.æôfL¯‰)^Ò\¼ëèNÒô]7&·ò›sLvWì´geÐ œ§"†ÇÌ«uL6W<*µ`)üÉ+)iºí‰¨¯Mñä¹ 24&<^c*rǘ®^&ut'Çú®›ÓsÄï4-~#Å$¤Èõ\¹Æ4Ô˜â{JjJpS`™.E»Žî$Mßu`r+¿õµƒg»‡+im|ÓëaÝr2î³ÚÁlò“Ø”qÖÍä'/ñ¦ÙÊï PÈfQ¨r¬6fÆï.©1Ü• ¤³œ»‰îäXßu`zŽøfÅo»z«YœBd¬ÊÓ`5£üÝ)b¾¦SÑn¢;IÓwݘÜÊo.º'ÐÍmJÑš¾­jLúp&Ý¶ä™ LcŠå˜ÀÇ”Ç=S~L³â7êu§„‰¡ªcjLÃÙ…ø>•‹|3‰G™ê—Ýɱ¾ë&Àôñ;M¼Ô5H² q3ð²6V³DoÆdÍmü¤ÁkŠe½MšëÀ„nå7ÛÒ®¯.§(Šª‹Œ‰õã+º{UÂV†Œ)è~7g›ûí/L8ÛóPt[)éè5\måjÓ(Ç ]“þÍìBÀ³‘wÝɱ¾ëÀ„Ï¿q¶ò[s¬CÇ‘È?W³Æ4bLº»“&ÍÍj†ðåGw’¦ïº 0¹•ßšäÁÆá1(:¬4¡„óa‘P—ð’–€ÉS±Qê%X;Æñ}–ßÓôÀKkW«$Z7µT• 4¦‘Ž©¸‹1%È7í›ñšbYGwr¬ïº 0=GüÆéžßYw!®'X4¦Áj–^³äìg´Ã¤›S9¼y×Ѥé»nL~åw(13æc¸ -2&{˜Š5zeiD¸2¦h¥•FØ"ò¸æü7À4Ýö$åLuCþ3ÇZÓ¨ƒ…¤‹•S"ºé`‰W/“:º“c}×M€é9â7Ίß1Ðu}¿¾’Ò˜F'&á})•”ï¶rüåGw’¦ïº 0ù•ß!%;ÎRҳʘìá̺ ̤ÿ¶¬1]Í¢Ÿ™Ä– àlå·V§@©¦Æ4ì’Êï»rúéÞ-~g9wÝɱ¾ë&Àôñ§+¿•\•„‰uçQX6¦Q¯ WSârWc‚W9wÝIš¾ë&ÀäW~+×±N’£”Õ:&{æEˆ&æ Ô§rº)Ñ]`²wl|æ7À4]ùMÐÖ"’JuW®1g¾'ñèoxǘ®rî:º“c}×M€é9â7NW~'”’¦Xu°lL£î‚™ÞŒ‰ß]åÜuô6i®{¹•ßù8~¶Á1Öœci+÷zX S8ä­µÖµ:¦¤ÏŠ ¥Ów퓌‰¦Ûž›% Qy TwåÓ°ç×[Ǥw¬œ®^&ut'Çú®{=Gü¦é—ÑܳµKÄúJJm2¦|íÿ˜îê˜èšbYGw’¦ïº 0¹•ßÙ&/¼Å.Ò¬jLú°÷DõÁ•û,/ÆÄJÔì®!ÃðáßÓ¤ø]"Çì c¨n4¦Q­Ü5"üèù}w»€Ò—Ýɱ¾ë&Àôñ›¦ÅoTt箹 •ÆÔ˜FŒ‰Âub’lr“4—¢]Gw’¦ïº 0¹•ßÙn &ÅgI,«,íaÂdmµ3­žÊéväh¥ÀdG£¦Yñ;CÁ,¨{[Ìõ\¹Ú4Ò˜Rºîc*cŠ7–t*ÚMt'Çú®›ÓsÄoš¿¹æ¨[‡øê¦ôãoe1¦ð®cJúBÝÑlþò£;IÓwݘüžßøê=VŽþ›«ŒI¶yt¤i\é2÷bLV–©L-”ä“uL4+~ë’¢+¥(ï-¥*IiL#Æ„x½(ùîÚŠvÝɱ¾ë&Àôñ›¦+¿ÉîU'HsU.ИFŒIèºÇ””.ÜôÊ¡«œ»Žî$Mßu`r+¿MFeÍq…–Ìa¹“Í¥<Ùz‘®jL…ƒ(&¦P†5翦éžß ¯=é3¼8Ο]RkÓ¨òûÕµòuWËøMW#ï:º“c}×M€é9â7ÍŠßv©m”dJTw¨Mà ô®cÂÛS9_~ô6i®{»•ßúþ(c±5]wry[NÆ؆Vç˜x­í‰2¦ÄXlëF?ÙZ—§Ûž$»ûôåO©î+_›F•ß‚ïîźºø9võ2©£;9Öwݘø9â7ÏŠß„œ™E÷Ø¡ªünMƒÕÌ._\Œ)ÝvàSÑn¢;IÓwݘÜÊïŒmB§5 [Ö˜”öØ;¨ûá²B·Æ„l]õBN1â¸lü7À4[ù ɤe«…ukÝÆ4¼+ß]R³ÜÕ1ñYÎÝDwr¬ïº 0=GüæYñÛºæëËr(TÝ•kL£ÊïßuLvËë&iNE»‰î$Mßu`º©ü&ŽºÕÈŠªÊ_W+¿mO‘Œ"÷]íÇÄX©( ø(cšxIÁnaK|õø1ð²2ú1•ô=‰GIéM޽§XVÑë»nLÏ¿yZüý¯5`“×Ü?ÅïÚ4ªü¦ÈoIîÊøR´ëèNÒô]7&·ò› Ùh'Ý̬ͭ„ëaë@Åþu•1̺©º5áñ àßÓtÏoaUÄ~ô3ÇZÓ¨ƒ%½k唦›a|5ò®£;9Öwݘž#~ó´øE)±n­õ[© ,ÓpæW¹V³ÄÈw«Ù¥h×Ѥé»nLnå7r½~ ™Òj?&AÝTÄ`M»õcXטB \>z*ÇÓâ·8Ý_* © ,Óˆ•¿*ÙÆtlsý»í:º“c}×M€é9â7OW~ë‡6€;ƪ*·5º ºNL”1ÝUåæ«œ»ŽÞ&ÍÀu`Ê7•ß!kŠÔým΋s厇³5h Œ¼8WÎxVIÆ1ÅŠ4?LyVüNºçŠ¢ «ëeUÇÔ˜FŒ)ñ»ƒ…õê¼É±SÑn¢;9ÖwݘòsÄï<+~[3mÛ#å¨*°lL£zÏ•KÂ]ÒœŠvÝIš¾ë&Àä÷üÎÄVä`3`¥F®‡uKYA5cLQ§cH8—Ÿ,°Ì“â·¾éÈ¢„ºT#ÂZÓ Ç¢„÷$žîZëæ—¢ÝFwr¬ïº 0=Güγâw¶áÈG׬Sc¬fÖÛìZÍtsS•›OE»‰î$Mßu`ò{~'›»6{’îáÂùpÊQ(„£KãcŠTÈŠ+(Yâ'Åï<+~3)ÝÕŸ‰CHUecêç˜Ýzz³òîú1åSÑn¢;9Öwݘž#~çYñA×W]ž#ƪƤ5õW3Œ&iœ«Yä»ý>í&º“4}×M€Éïù•õ &¨®jLú0夵Øó;*[Ívo‘)–Žoʳ=¿c гA“¢Ô“xS?Ç@$}ë˜/öäåØÙÈ»‰îäXßu`zŽø'Åïl‡‰(æS%L6¦þj†AJ¸Óýøæ\¾üèNÒô]7¦»žß`‘HwKúõÙó‚þÎú®¤E)‚~^k%w™û 0MŠßEùs´‰-ÁæV‹_mÕÊñ{Ús*ïrL¾üèNŽõ]7¦çˆßyRüÎØæ]DP$©ŠßÓ°» ¼W³r{bR—½MšëÀTn*¿CÔÍw\¦ãa%ZVôge–‹uL˜¸”lƒù£–e¶ç·R‘ hÝXšf„it*'ï~Lhùp“cñËîäXßu`*Ͽˬømtߤ?²£¯ŠfצQUîkûöêÇùF˜,§¢ÝDw’¦ïº 0ù•ßõo»-÷*P^;•Ó‡È}ë'×Zëc¢£Ê@WüI`š­üV„,ˆV¼¹*°lL£“_o¬ÆËϱ³œ»‰îäXßu`zŽø]fÅo&]\mx+$©.ñ6¦á©Ü{®œ]»½¹ÇTNE»‰î$Mßu`ò+¿uV‚Mu!®è×p>Ld•ô¤ägià¥2¦HÙʾ¢î{aÜÔ÷7À4-~c) `= .°¬MãÊïïI<¯»™^Ž]ŠvÝɱ¾ë&Àôñ»L¼,¤/€m^›¯?‡Ö¦QwAÝw¼ÝMI)×Ë:º“4}×M€É­ü.! ÉQ~-‹“=•&æ¤[b^œÄ­ÇÊ+cb›výA`š­üV3€Mdo~Sc1&(WŽY¾»;˹›èNŽõ]7¦çˆßeºò[ß›c]ÊOšÝšF½r \?câ|»š]åÜut'iú®›“ßó»Øk›©aíïëa ˜B±Á•‹,Åæÿ–“î"¨›Tú=0MW~“rGe¼€RªîiĘð»»@°ÎÁ~Ž]åÜut'Çú®›ÓsÄï2[ù ؤÀ±¦Æ4bLß“xí.ÆMÒÈYÎÝDo“fàº0‰_ù]DáÂÉÖà¸Úó»K*¬ø„똬…g±:Aý/~˜d¶ò›CKÝŒcŘÓð>fú®•Ãp—cg9wÝɱ¾ëÀ$Ï¿eVüF%7D{÷+`ªM£S9üž+ǥܿɩh7Ѥé»nL~ÏïBVcGÚl»EÆDõ1’\4ÈcB}Ãôq`}Åè“À4-~³îÂíW" 50Õ¦c‚’®“oîcÊ¥h×Ñë»nLÏ¿eºç7Z?‘ ™ëFqµiÔ¹ät1¦?ÎKš«‘wÝIš¾ë&Àä÷ü.9&²Öùi< fL9ˆ$(A2­Þ•‹ìOVÒDú®Á'iZüŽQÙ£XÕg]’Ò˜†Œ Þ:¦”»K¹í:º“c}×M€é9â·ÌŠßv~V”'|ÍÑ­Zëþ0 g~áUùr¸›ù%üåGw’¦ïº 0ù=¿3‹µÝ䨼'¬jLÙ†/&Ý’)óÅŶ'L9ëv.`;·Ò‡ñSÀ4+~k6ëx «’”Ö4Ô˜¾»¤ Â]ŽŠvÝɱ¾ë&Àôñ[fÅï4{­æ%F©†4¦Qåw€wÏo}·nº È©h7Ѥé»nL~ÏïØú SÀêƔåˆ¤ÏÆ¸2-óh{bÁ,6‰(•ãúðÇÓ¬ø­?ŠRÀ£ÍÔO`jLCÆôÝ%U ß±rùò£;9Öwݘž#~ˬøC$ê×­¯PÕZ·1 îÊŽï–¶ q“&…SÑn¢7I3rݘRûÕ½*¿K†’ŠB)”qɺò»°²-]¾•…ޝ»ýL+Cµ›,úWzýɦóë™È±`»$Ýé–X/~µiTù] ½sìµLy9v–s7Ñë»nL)?au-9(+¨NåÓˆ1E~W~ë»å¯f)\S,ëèNÒô]7¦»žßtS {2æ¼Þó;@´YzÙÖÇÄ@Gu§|˜fÅo:¦Y©™ª­\c1¦ÞS‰|·øŠvÝɱ¾ë&Àôñûü¼ÇI£K:—Ì6ˆ>pÕö¤1º äxÕ˜¤b7ü¤Á/?º“4}×M€É¯ü¶Zf´±r4¾±V1&[¼É®¹Û”ÅáÙ&µëVž¬q8°\àüzÆ9–KBA¥7X°¾(Þ˜†§røcáfO §¢ÝDwr¬ïº 0=Fü>?ïqÒJ¦²ê6Œ¸®ünLÆã÷©œ&ÍÍ>í&º“4}×M€É­üÎAÐÛ%I&a¯v°”ƒ~&$»½µÆ˜2‰.ûd÷åm©ø$0M¼,È9QÒXuòÛšFŒ)áw?¦r3T5…kŠeÝɱ¾ë&Àôñûü¼ÇI£Ûj‰” ÆÀMåwm0&ÀøÝ]@nšxéîâËî$Mßu`ò{~e,B’ÃQ1°ØIå[ÁÆ;¬´&8“õ5Ai¦~!Ç-½ÓlÛ+ÙÖF¤>ùmL#ÆôêZyvI•;Ætö2i¢;9Öwݘ#~ŸŸ÷DÒX³CSCteÇŠ15¦cÊå›1ÝÍ•OñT´›èmÒ \÷¦èV~3+$"&°6Õký˜ôWBŽHfñJŠÍ±Ó] ÚÒOnåâlå7r‰ÙZæ VÅ[Óˆ1|çK¾¦x–s7Ñë»îLñ9âwœ¿u×€‰8éò^*©1 Æp˜èª}SÇ”â©h7Ѥé»nL~Ïo‚,ÖZ X+ôÅS9{XpÝ)Ö¯‰ßáïu'—õ±ÊèôÉ­\œ¿‹xe»J)Ö¹î'cªM#Ɣʵr|sÀÓ—Ýɱ¾ë&Àôñ;Ί߂YÐæŸÑk\åÆT™Œ ^MI_Œéuèê% ~ùѤé»nL7=¿Ûeõ˜R¤¸Ê˜ôáHÙPY½Ä«{Þ,¥Ä„> Ló•ߦ+ëºBsW®6 5¦xMIIœo®¤èGþåGwr¬ïº 0=GüŽómOlÓ‘­Át®4¦Æ4bL¯ý¿¾St—4ï^&Ut'iú®›“ßó¸` ›á–ަ¨Œ€@™ç¢Æ„œ¬zYìês)üI`š¿³Õr±W¥jJJk1¦k ½1¦ˆ~£¸OE»‰îäXßu`zŽøgÅoB›Ø® sI¡&Ó€1évë͘ô½¸91‰§¢ÝDw’¦ïº 0ù=¿£ò»˜ô·Zšò çÃÖŽI¬›ðJk‚tVY…|°‘×’bø$0ÍV~³Á³”lÒgÝ(®6g~wIöïÊ¥x–s7Ñë»nLÏ¿ã¬ø ±dB»ÂP¤¦Æ4`Lôê–|öʹéÇ”àT´›èmÒ \÷&p+¿­I¹®½b³ºËÊu78†lÍâô3XiMp ¼,6"MŠnã˜ä“À³â·®RHJK|µüsàEmM{&x×1é'tØàT´›èNŽõ]÷&xŽø ÓmOàxsH×¢òs5kM#ÆÄåÏ›ß7U¹põ2©£;IÓwݘÜÊoº³-BV¾·È˜‚½$V´E¢ˆ¼xW.(³TƺOá“WR`¶ò›ì‚ €èÛ_µÖiM£¾òQÞ9–_“¼;˹›èNŽõ]7¦çˆß0)~笫j±e„TÑìÆ4bLÄßÝñN˜üò£;IÓwݘÜÊoŽ!ƒn?1Û[ìÇdÛE÷ÌpèvkmO–8%%Mù“À4+~+)ÅîþŠ15¦Q—Ô?kåonÀ©h7Ñë»nLÏ¿azà%1˜¶œ`5Z§1Ó«“Í‹1ÑÍ0‚×Ë:º“4}×M€É­ü&« 5î’“uà^cLö0D›Í‰WOåsÑÝ Âyþ\Û“óëçXÖ5…í¦G .•øÝ˜F]Rƒ¼+¿Kà;`Ê_~t'Çú®›ÓsÄo˜¿ôë°+ ¨ÿ§Ò˜jÓˆ1éW{­f"7ý˜œŠvÝIš¾ë&ÀäV~SÖ}­®¾„Öha©íÉëa›†®ÛW‘•êÌ£À’‘;¾"»óüw>LÓ=¿5uwªhYÚ»r•iĘ(¼û1)öÞiLW#ï:º“c}×M€é9â7ÌŠßDWt»ë)©iÀ˜(~÷ü¢›“¾üèmÒ \÷¦äV~“õ¶I¸úSÓÚÀËãaݳèLóÈ‹,ÅG¥”ÐŽ¾K¼ŸbLiVüÎÊÜ”Ä)dJ©ê˜Ó¨K*~ß•+rwW.ŠvÝɱ¾ëÀ”ž#~§Yñ;e‰úëêžê¶'iXÇ”ßU¹r[c’NE»‰î$Mßu`r+¿­†nÄ)é½ÔZ÷õ0F;».¸:W®V2YßÏüÉS¹4+~P¢;Z;ù™c­iÔWžø}W®Ü–¤¤SÑn¢;9Öwݘž#~§ÙÊobQ¦“„#‡êT®14&‰á͘B¼Ñ˜ÒYÎÝDw’¦ïº 0¹•߄ָ$£ p/Ö1Ùú³`RpÉyi¾¯ÖýÒ†]EÊ’>)~§IñÛ.¡Ù%lIê’”Æ4bLôÇíºx‘}ùÑë»nLϿӬø­ËzT1K5Œ 1ÓkûöZ͈î€éT´›èNÒô]7&·ò›’H$ÚÉÑr?&{X÷q™u?&+÷Y^â·XO_}>QÀOvHÓâwÐU"ê7jñ»6“„·ŽYrº“ .E»ŽîäXßu`zŽøfÅï(ÖÏLØ$z5«M#IÊû“0Ü%Í©h7Ѥé»nLnå·î¦tS€ƒŽ«§rúpBÅÅ–Å+),КÌk–þQÆ4]ù-ú»$ÝÛJŒõ””Ú4`LðαRàn+w•s×Ñë»nLÏ¿ÓôÀKeý6êOYIj ,+ÓèTN»*W0ÜÔ1á5ŲŽÞ&ÍÀu`B·ò›rS˜­3Òâ]¹ãa´tÇÍ”5Ƥœ¨„Y—~ ÀŸ¼+‡Óâ·õ¤â¬ KªÇ75¦Ñ$€?꘎?Î˱KÑ®£;9Öwݘð9â7N‹ßÖãÈn`iÆ7Õ¦câ¾5&ºk—¢]Gw’¦ïº 0¹•ßTŠÝW/t¨cK[¹óa¥‡)¦y ˜Âß‹PÐ`Qº>¹•ÃYñ[Šò>ý…ô·¡ ˜Óˆ1|kLœoê˜0}ùÑë»nLÏ¿qzà¥.ÎEÄ:ýcŘÓˆ1•ôž’¢Û›S9¼¦XÖѤé»nL~åw]Ðð¸vºXÇt<¬ï`vv½8Œ@w"”u H`Ó醨ö`š­ü¶nµ…8RnçÊÕ¦Ñ$žWáîÉÊé.ÇÎrî&º“c}×M€é9â7ΊßÑØUiNåÓˆ1qø£ò›îhö©h7Ѥé»nLnå7ÝMgX¹UçÃúŽ€"rƵ­œ~\”’]"ÖÝï°Öà7À4+~ÛÉÚ”Hu¹@cMâ¹€éØÖ¥;¹àT´›èNŽõ]7¦çˆß8-~+á·v´ž¢0Õ¦Áj–“|÷c |·š]ŠvÝIš¾ë&ÀäW~K°ÁÄY²Õ†.v°´‡ÍÀ±‡DP\"I!1 Õ­ßÓ¬ø-@(LºC¨.ñ6¦cRÿ·Æ”ÓÍEq<í&º“c}×M€é9â7N¼ÔÕ9ˆ]“ªSc1¦?öÿËMÒÐ5ŲŽÞ&ÍÀu`"¿ò[”ð8†NÅ•Ix=œG±gi1AÉ9“ž+Åü 0Ѭø‚õaÓ—ŸsuòÛšF}åCxO{¸+I¡SÑn¢;9Öwݘè9â7M·=¡IéSäúT®6Ó«Õéɘî4&ºz™ÔѤé»nL7•ßåµýÌ1-ÕHÂùpŽ¢d‰•9-Xc²Ú§úGƒ®ÿŸ¦é—EáÄ#Tí›[Óˆ1…ò}W.ÞuI¥kŠeÝɱ¾ë&Àôñ›¦Ûž¦#ýC®o~7¦ÁjV$]ûÔ½È0]½LêèNÒô]7&¿ò[7žÖ÷$aY>•˺£d]Ët{±Ì˜²âQJl¬Ü'Åošîùc ¦j+ט†³ C¾S‘xÇʯFÞut'Çú®›ÓsÄoš®üVâÏl\$ÖmOÓˆ1É÷Ío‘»â7ºÊ¹ëèNÒô]7&¿òÛÚuëÚË%+{]eLú°qÚü…°rÑîdLJ·(–‡ôI‰fÅï£ÓF»Ø]MIiM#Æ”ÞïAÊB7%)t*ÚMt'Çú®›ÓsÄošx©{$«š¡$¹š+טFŒ©ä«Ž ÉÝjvM±¬£;IÓwݘüÊoý‘ƒ¾FÖFz©\àõ°P ̉e­ƒåq*G˜‹’µ`à > L³âwV|µË$¢d¤fåµit*Wþè.|ÓZ‡NE»‰îäXßu`zŽøMÓ•ß‘5‹•Á¤ºQ\m¬fËuWCN7å|•s×ÑÛ¤¸îLìW~›R6Ùu©íÉñp¤cÒ7'U)$ý£KTâÕ~L<-~#e. úPÕ©1Óë\öÔ˜ø†•ó¥h×Ñë»îLüñ›gÅo›Ú%CŠ©ÞÊ5¦þjf õu c¹kǧ¢ÝDw’¦ïº 0ù•ߺîZùæy¼¡ªS²çABfe>«­u•fY—˜lô'ÏŠß6õ‘SÑýx=%¥6S–÷í‚\ÂÍ}L>í&º“c}×M€é9â7ϊߺì`Š6h(VÃZS5³ýëgT¹k­Ë§¢ÝDw’¦ïº 0¹•ßÄ¢¯ˆÝpXFp<\íX M•]cL6­¸Ùù·©L¼’³â·þ8Jÿ2“`=ð²1 “ AoÆt{‰—OE»‰îäXßu`zŽøÍÓ=¿õÝ9N¶©ÔuLi°š œÃr#ÜÜcâ«‘wÝIš¾ë&Àä÷üæ(J{L鱯߫Ý $ëø³îS±ÆBœ‚1ÉG‡ðôÀËÈ6~“Êbu*טFÓž1¼çʉw9vM±¬£;9Öwݘž#~ó¬øí‡2þ)L¶¦‘Æ$é[c*w,¸|ùѤé»nL~å7ELVNLº«ZfL -€ IlžÞâ©\e®%XËáôI`š¿sÐ}-*b"W–ic±ü1%%–›’¾í:º“c}×M€é9â7O÷ü–œÙŪPiLµi 1ÅW'›—ÆÄåf+—¯FÞuô6i®{Sö+¿nˆH!Z'Õ–””r @V†¸2û)EP1H”1á'·ryRü.vsÕ?BsÀÒ˜FŒ‰Ê7cÊáFÇÌñËîäXßu`ÊÏ¿ó¬øm§ðúþ”±îùݘFŒÉzß_Œ)…›“|*ÚMt'iú®›Ó]Ïï(Ö` bx5Yëù ¢“EЬöüNÂ)çRBÑÝoÁOÓ´øvCF©H¡nW›9–÷•‡t—c—¢]Gwr¬ïº 0=GüÎÓmO FëWšÏ•?Æ7U¦á©~3¦x7%5_½LêèNÒô]7&¿ò›L(*1Ťÿ\’Bd͘X’¾z+³ŸŽS9ë]lž ø$0ÍöüY¬p" ¿ªÛþȱÆ4`LšØßwåR¹¹’’ÏFÞMt'Çú®›ÓsÄï<+~C6<Á(Tã›[Óˆ1qº*¿uí¹»’’OE»‰î$Mßu`ò+¿­ ž!r†B+×Ý^,%&ÌQƒÈâV.g>¦’ÛòGÍù§Æ7åIñ»X­i±kƒŒUåwkõ•—LïKpLùËîäXßu`zŽøgÅo,ÂÖSĪ«–iTùè™_ùNc:í&º“4}×M€É¯ü– ÑšÜEë°Þ] P„l³á^'þ [9fÝSëG…éÕécŒiVüFÐ áÑÕ©\cõ•/éº+‡áu7Ó˱SÑn¢;9Öwݘž#~çéÊo»Æž8bLµiȘèI¼á†1•«œ»ŽÞ&ÍÀu`*~åw ±X÷ÌÂjÏïR”ŒV¦ºtŸÅ’K‰A÷½ÅDª#(³•߬¿OàÌúÎC­1Õ¦!cŠòcxØÊYÎÝDwr¬ïº0•çˆßeRü¶Â²À)™H›Šß­i¤1YûŸk5Ká¦\ À—ÝIš¾ë&ÀtÓó#Úæ–Mÿ^=•+9ؽ^)?ÊYXÿkó2?ʘÊôÀË”’Gk™ªÖºiÔó+¦÷í‚Pîú1•kŠeÝɱ¾ë&Àôñ»ÌŠßœôõ)Éþ®;X6¦ÁjV^‰röüNwÀt*ÚMt'iú®›“_ù#qÎ eõ®œu­·€‚Ëâ0b¶sL«¢²BŸÓlå7Ù†ɦ¶U“xZÓ¨¯|.W_y»t{ÇÊÏrî&º“c}×M€é9âw™¿ t™Ð4¶Î¢Õ‰Ic1¦ôGwx7W®œŠvÝIš¾ë&ÀäW~e°ê,Ï•³¯Éú ÛvµíIŒÅ~#Øe˜O^â-Ó/£óÝ¿†Èÿ¸+W™†Óžù¾ò·¬üšbYGwr¬ïº 0=Gü.Ó=¿ Xw,Ä„±j{Ò˜wå¬Wã{5+GÅ‘—4W#ï:º“4}×M€é¦ò[„­p&Àq󑦎IÉ–¨»W.K[9ý¸’•(é®WWÿáyào€iVü¶¦w%‚,Qµ•kL#Æ”àz’¼ø³—c§¢ÝDwr¬ïº 0=Gü.ó/£~#%Øsu”Û˜Œ ^·½Ïîw­uå=ŲŠÞ&ÍÀu`¿òÛ¦|G°‰º «“ò‚@9„V;X*c²_be“L”ÿ˜dZüΘu]ÑЍº’Ò˜FuLR®K%Åñ[.E»ŽîäXßu`’çˆß2ÝöÄ¥9EkÃÞÖ˜ü4 SÂòfLå†1ÉÕˤŽî$Mßu`º«üf›%Aߟ²°;S.Ù¦¬èfVÛžä£RQª?Ùó[&Åo%"ràšËÚ4:•ãøžö\Xî€)}ùÑë»nLÏ¿eVü¦lý¹cIúÕSm1¦ôc‚;š-§¢ÝDw’¦ïº 0ù•ߦÔ.DÉ3­v(&E -(çc*B¨$“Ò }r®œÌŠßr´äŒ!fäz|SmÕ1Åø=‰Wî&ñÊ©h7Ñë»nLÏ¿e¡ò[²èÖÁšøü¦Æ4`L@ø¾+Ó]ñ›|—sÿŒî$Mßu`º©üŽtuOÙ:#­ŸÊa°rUÌÖth1nÿRB,lCøI`š­üYyˆnK­Adu» 1 ¿nœ“Üôc’üåGwr¬ïº 0=Gü–ùžßÖÀ5r¶ÂןIÓ˜FÝ(^÷˜P—ú»­Ü»‘wÝIš¾ë&ÀäW~kÖ"º³þc«SRJ± L%*ÆäñÁZUùmýÑA·r‘cùèø&™¿Y Ü1ç¶DªÅ5¦cʯVgŽÝÕ1‰|ùÑë»nLÏ¿eVü–hW÷K ‘ëýcÊeù®1¡›K¼NE»‰Þ$ÍÈu `Âö«;SAÌ ¥¥Ø\óEÆA·€È,Žo‚£(0*6ï³ü÷ÓùõŒs,'(º?R2‚ 05¦Ñ©\IWŽ%‰7r†«‘wÝɱ¾ëÀ„á1â÷ùy“¦è†ƒc%±œê­\m0&,ß,¡Ü #Äp*ÚMt'iú®›“_ù³S‰Š«§rÙŽãlÀw`ÂÕ»rº ”b˜f]D?¸•;¿ž‰‹Öº¼ˆuv+?o´¦‘ÆD᪕³~LwÀ”¾üèNŽõ]7¦Çˆßçç=NšcMOœA4mOkÓðTî=WuáoRþåGw’¦ïº 0¹•ߺ™ …b*™p±ƒ¥>œb;(* ‹ã›’n¢m~éƒuLç×3Î1}飀- ¥¦Ê4º]€ðc}Iùú—Ýɱ¾ë&Àôñûü¼'’"Q±cR| _ú“1Õ¦Qå7}wS|ý¤¹í:º“4}×M€É­üfÝHÙu7£M‹Ýôál¹õì°Ø(NYˆ`šHU>XÇt~=ã³a¥‰­HHjVÞšF9Ò7+‡ìw°Äp•s×Ñë»nL¿ÏÏ{"i²uÄ d3†ª»r­i4%%Ñ÷‰I ;`*_~t'iú®›“[ùmí'ËÑbH‹§rY±‰ÕƒÂr“>(eC§”ÂG„Ÿ_ÏDŽQ$´601—ºò»1tLât1¦t7ðéh7Ñë»nL¿ÏÏ{œ4s¢b­óQj©1¦¤Dùž+ LñÝˤŠÞ&ÍÀu`ŠnåwF+ µÛ¸Œi|1ägÒèÈ "ØttZßPJR,ÌV,8î™ò `гâ·-Y#ek4USm²r|ŸÊé†÷FÇŒñËîäXßu`ŠÏ¿ã¬øŒñ£F,uËÆ4bLÞ'&…ùF˜Œ§¢ÝDw’¦ïº 0¹•ß¹pÀL\À0f±ƒe¶îrJzc0•h±ƒ% 1X‘¥èÖ÷“Œ)N·=QêG@ĺ«®¤4¦á$¹z~Ùµ§›“ßxõ2©£;9Öwݘž#~ÇYñ[”…è¾=F©ŽrÓˆ1•ô¾ù­ÿzC³ã©h7Ѥé»nLnå·B ƒMw•€È‹=¿õaý…¹”bÞOå¢`Ñ?Z7tú‰¥OjLqZü¦ôû©§¤4¦Q­\ŠœüÆ;V~)Úut'Çú®›ÓsÄï8)~gÉ6DíP¢T«Yc¬fJ‡ßŒ‰_…ý^Òð—ÝIš¾ë&ÀäV~ Ù阒%¦ÆôOÆ$¶t+ ÛØÙ¥#½ã®œ ¹¶¬€ü“À´ ~#B’ë“߯4¾ù®•Ó½_`©™òåGwr¬ïº 0=Gü޳•ߺª‘©PL­iÔ]ñ}*GtWüÏrî&º“4}×M€É­ü# ‹0Ƽv‰÷x˜@ì¶›ÍZØŒéhãd•÷•¸~˜¦Åo릋¬€©1 ïcÂuWΚàÜ1¦KÑ®£;9Öwݘž#~ÇYñ;!å‹|­¶r­iĘ€ßý˜9”›ý?œŠv½MšëÀnåwÔ”µc* Kétr“JcÒ‡•pE;^ã׈ðɇ_ã›(ÚI¢Œ ~L0]ù­T—“•1èù˜ÓðvA¹N~u+‡7Œ ®rî:º“c}×=€ ž#~ÃôÀË¢K«î­)ªŠßÓhJJàwU.S¹aLpM±¬£;IÓwݘÜÊïãš›M…3ûh>2 Lö°õ°b&8ªi`²~LÁfÒ§Rh|}ø7À4+~'°N!é>¬½’R™F:f¦ïÙ…áf =Búò£;9Öwݘž#~ÃtÏï(…Øš±"VwåÓèT.À{®|Ö­×MÒ\¼ëèNÒô]7&·ò;+±´"9[*-1&fÝ ³móq°¶Â˜ÀD&"ætùI`šm{¢tW9`2Ý«ªÚšF¬\Êõ$å6w¬üìeÒDwr¬ïº 0=Gü†ÙÊï¤;† e2AâçV®6jL$|Ï•£»r8˹›èNÒô]7&·ò;FˆºŸb)Ph‘1YEk ¤´ii+g=¿…άO:LTPý˜æÛžûMtS õâטF¬<¦7+¼Ó1áÝˤŠîäXßu`zŽø Ó=¿sÎÉîzå°?“¦1 kLà=W.g¼¹+W#ï:º“4}×M€É­ü¶nL¶ùÔ˜.2&}¸(¸Dδª1Å$á(fÂÀãn㿦Yñûh¦•mp¹äªò»1rŒè»¯üKqôrL¾üèNŽõ]7¦çˆß0+~ÛøÑ¬_ 2Ǫµnc­f™Þså9ç`J§¢ÝDo“fàº0%·ò[ÁˆRެ?{)ea7çú…³FTú&.TcRj)¬ rÁOöü>¿žqŽeNÈP.±@Ýó»64& w—ÔoF„aºy×Ñë»îLé9âwš¿OÀ¦jªû15¦!czOII™Â~/i.E»Žî$Mßu`r+¿mA†h*‘‚ôÒVîx˜ôW5í¼$Œ‹Œ)èmâmHù'iZüƬˆ¢C R‹ßµiÔ]àÕ²ùìÇtÓÁÓ¥h×Ñë»nLϿӬø ‚le–X÷ÊiL£ª\‘kJªî&ðFüN§¢ÝDw’¦ïº 0¹•ߺ ;îƒêv.ëžc•1‰UWæ’Ñæ/®1&I¶'Á¤ë¡£‚êC/ϯgœcV0¡(¢\¤@®€©1:XÒ»Ž)¼eå§¢ÝDwr¬ïº 0=GüN³âw šÅ¬§v¥1Õ¦Q w¸oâ•NE»‰î$Mßu`r+¿£"ȺïH9ð"cJluPI_=Ð]Ýc*‚ ˆEwG§ôOÓlå·ò¾DÖjX)N}» 6½ïÊi>ÀÆ”Îrî&º“c}×M€é9âwš®ü;^±“zDxmNâ=Åÿmån÷ÿW9wÝIš¾ë&ÀäV~Çd¤™.G«¸EƤgý!‚¢ý"c*¬ûÞ¤é³ÇyàÇ€i¾í äl£”ók\å¶'•i¤cj¼Y¹~<79öîeREwr¬ïº 0=GüNӕߺ±¶søhëìO`jLêÜü^Í ßµ¤À«œ»ŽÞ&ÍÀu`B¿òƒ‚s¶¾Tôj­»Â˜ìb`+“À–ÄoeLT rŽÈE©fù 0á¬ømó·•=r¦RªS¹Æ4bLß:f¡›¡ªˆñËîäXßu`Âçˆß8Ýó;['ÖƒuÀ¯4¦Ú4Ô˜Ò[c*œï’æjä]Gw’¦ïº 0ù•߈H\ìˆG³}i+÷zXô]±IL¸rŸå`L¢ˆÆ…)«fþ$0ÍŠßl½Ç¢±ÈŸÀÔ˜FŒ ù{¯"ÿMŽŠvÝɱ¾ë&ÀôñgÅo}wì>W(ðÚ±ÿLiĘäûÄD)÷ÍVOE»‰î$Mßu`ò+¿ÄNz¬ÚÓ­’cJ!* •!Èb“ éÛ«ÛÈ`§¤ñ“À4Ûö$p$;£ŒRª—­iTùå­cêf÷˜Î^&Mt'Çú®›ÓsÄoœ¿)Ú;d28UÀÔ˜F7¿©¼û1Y}ßMÒœŠvÝIš¾ë&ÀäW~cÎDʳnÈÊê]9«Ú ÖôÛó.ЭWS´'mâµM¶û`¹ÎŠß©£·A‘¤îùÕ˜F§rå=»0•oXðT´›èNŽõ]7¦çˆß8+~ëÊ%$Ô¿±ßT›ŒIÉÁûæw€»ax*ÚMt'iú®›“_ù­$¢&zI%Éjå·>¬K„ v$¾XÇDh3€#c¡üÉÊoœ¿‹þ( ’º×…¥:`iL#Æ”ä»VÎöÈ~ŽÉ—Ýɱ¾ë&ÀôñgÅ¤”mf{© ,Óˆ1Y—÷‰ÉÝjFáËÞ&ÍÀu`"¿òÛ.“Â’Õ_¯• ¼NR¤”q¹»€ÂY8WT¦É&š®ü.!ƒþCA…+ñ»1 ûÊçï:¦Â7µrt•s×Ñë»îLôñ›&Åï,hÓ^‘õ§ºÆ¤6 pþîù]î.ñ|ùѤé»nL~å7C k²hóðCL1”˜J.e ˜ŽÀs M’|²QM÷üÎ ( „B U¹@cu°PÔ½rL”ÞäØÕÈ»ŽîäXßu`zŽøM³â·½=vRu*טF§r¯»KgÓ]k]:í&º“4}×M€É¯üæ`!OS\*x=œ) @±IL«“¾¯LE‰Pþd£8š­üFò­<^ç`jLCÆÄœüÞÝ. ³œ»‰îäXßu`zŽøMÓ•ß`“<ô ¬î1µ¦Q?æ¿çÊѱ²yIs•s×Ѥé»nL~å7‡lÅzºÿ4­h•1éРɦ¬¬t™{iLÁ9k0©ÐöÑ­ÜtåwˆFý¬p¢:`iM£û˜!¿{~ä“®rî:º“c}×M€é9â7M‹ß1êòªY¿˜ªçwciL¹|ïÿó]ÛSºí:º“4}×M€É¯üfÝÅ`E¦’VHÏ‹1)ãMVIa‘1IIƒ p,Tò'ë˜hºí‰‚3´ò,¨ê˜Óp/^SRLǼÛÊ]½LêèNŽõ]7¦çˆß4]ù¹èÊÀ&·ý¦Æ4¬cŠß«Ùí%^¾Ê¹ëèmÒ \÷&ö+¿Y7q¢«o°ûðË+˜Åt`ÛÚ%^›d ˜DY¿T^ûÀOÏŠß%˜j&G+¶úomiLù;Ç„înð©h7Ñë»îLüñ›g+¿‰a²q÷cjL#‰¿§¤ä|WùÍg9wÝIš¾ë&ÀäW~³èî )2@æµÖºÇÃrNv ¼ÔöäÕ—WAÍJ3I>:‰—gÅïˆÌ鸻ÿ³$¥5r,ów?¦Wo&/ÇNE»‰îäXßu`zŽøÍÓmO ¥hWt±¨†4¦Ñ©Å÷‰IIwâùêeRGw’¦ïº 0ù•ßV#Y·žÈY–5&´ºý@m3·ÚÁ2X_ìP”˜4÷I`šn{¢é˜¦*`jL#ÆDá›1Å|#ðÕˤŽîäXßu`zŽøÍ³â·’ëvTb5¾¹5V³BßÝ^ü½¤9í&º“4}×M€É¯üf¢ˆºó$Å—5ñûõ°‚|ÔÍkŠeñ®œÝe%MŠŠ$å“§r<+~+×_E+ÿ«ÊÓHcâï:&M‰;Æt*ÚMt'Çú®›ÓsÄož¿mžt ”éh{ÿ˜jÓˆ1I 7cz­l^ÒœŠvÝIš¾ë&ÀäW~³]Â%¥<¹dZí.`q­í¾]–Õ–Ñ:ıý3•Nâåiñ;EÈ¥(…„êvAkÊñÝR¼Ó˜.E»ŽîäXßu`zŽøÍÓ=¿Åjø‚µ¯OÕV®1NåJÌ×jVR¹¿óÕÈ»ŽÞ&ÍÀu`Ê~å7Ç)&`Ö6h‘1ÅD1+Gb\ž’¬Ó8åM)}˜òtå·íÃSȹ¼ÎÑþ¬ü®MÃ:¦ð¾+g׺orì*箣;9ÖwݘòsÄï<+~'¶{‘ºu·n®?©1îÊqŠïýÿmñ[>í&º“4}×M€é¦ò;ÚæÀÆâ†LËSTj ™¢¢Ó2cЬÄÒZx|Rüγâ·ò·Ì"Ê|s¨G„צQ?&ÁïÙ…Tnä‚|*ÚMt'Çú®›ÓsÄï<)~g»ƒžmâ_SüV›Œ‰0\U¹âøñËî$Mßu`º©üÎ JB…S a¹ò;'椧íèþ;îÊ>›%@ÌŸ¼’’gÅo¡h³‰‘R]ÇT›FŒ‰ó7+w#Âò©h7Ñë»nLÏ¿ó´ø 4–$‡ªŽ©1 +¿Ëw“ÜÏ—¢]Gw’¦ïº 0ù•ßÙ$ 1æ£?þjwlûÀ$º³ ¼V`iŒÉ©Hº |A} ˜¦^Ú°òÄ1Õµrit*czç”»­Ü5ŲŽîäXßu`zŽø§+¿ `Ñ÷PߤŸIÓ˜Œ)Aüc‚…›¤¹Ê¹ëèNÒô]7&¿ò[ ‹SɈ)¤UÆ”­9͇…µFqVÇ”Áf©+„ú$0M÷ü¶Bˆbݾ¹5N~_Ý’ÎÊï»Z¹|5ò®£;9Öwݘž#~çYñ;XÿW;d®ªr[Óˆ1qùcJÊ]wÁ¾üèmÒ \÷¦âW~È -ºS²n°kŒÉê½u3gÍq,”Ÿwå¢EÛ,„>YÇT&Åï¢ìM*ë \/~µi8‰ç)))ÞåXüò£;9ÖwݘÊsÄï2+~gìÖD ©Å5¦Ñj†ð^Ír › –åT´›èNÒô]7&¿òÛFtŠ1•¬ÛEƤ°®ì•wb†åI¼€J,râãG·reVü¶ëÌ8SÍ~2¦Æ4ì+ÏïÛ‚é¦À²œŠvÝɱ¾ë&Àôñ»ÌŠß6F)é¦A©ÿϤiLÃÊïï“\îŠß ~ùѤé»nL~å·p¶1è›´\ùm/[y¥u_j­kS´JTfÅÆøI`šíù v¯8(ÅÁú¢xm±r|w°Ä@ñnñ;y7Ñë»nLϿˬø­ë²Ø«oÂ_µ•kLÓò^ÍèuÒKšSÑn¢;IÓwݘÜÊo8Š8°"Óâ$^}8&ÎúžnÊVSŒ ådûÞcïÇ€i¶ò›óQZ¥«eÍÊ[Ó€1a~ŸÊY]ý0åÜMt'Çú®›ÓsÄï2)~g±’2E(ÇŸûÿÖ4®Ê}Ÿ˜Ðí””R¾üèNÒô]7&·òbÌhZÈ:,2&{¸˜tº\»Ä«W…4›C¤{ëòIñ»L‹ßšѺ±@äZü®MÆDÄ×{€QnsìR´ëèNŽõ]7¦çˆßeVü¶› •õëß5Í®M£™_ÖöbLáŽfKøò£·I3pݘĭü¶óœñèBeqJŠ>í–02,w°Dåi…õ£²zOV~Ë|ÏoàŒ™mw͘jÓˆ1I oÆ”ä¦\@Þ¼«èNŽõ]÷&yŽø-³â·¾;!@»éV˜4¦QUî5¾Y“œ¸IšSÑn¢;IÓwݘÜÊoˆ)Y“rL6+~ËtÛ",%±Õ UÝÓ¨SÄ·Ž™o‡ÈÕˤŽîäXßu`zŽø-Óâw&]oR%~צaÏïð^ÍXn^R¸í:z“4#×-€‰Ú¯îŘ춠X!±ÍvYeL¢»Š„€ôí[cLVk TD!M_¶Ö1_Ï8Dznf•ëf²9:ÍìÂÊ4ʱ¾gjšß䨩h7Ñë»nL#~ŸŸ÷8i g„të€USc1¦ðÝ]¡øU¹NE»‰î$Mßu`r+¿!dÎY÷dú9äu)ç(GÅ;Òj¶ñ¿E_1ýÃ?Șίgœc9À±¹´FèÕV®6S¦wwœoF„éøËîäXßu`zŒø}~ÞIS”õÛz¡´ê µiȘð›1òOL(\åÜut'iú®›“[ù ‘0Ƥ0QdùTŽÐ®ØÙ]úWä cŠ­AŒ½ÂôÉS¹óë™É±Lñh(P ¼hM£Ûð~’·ÀBájä]Gwr¬ïº 0=Fü>?ïqÒŠš¾ºP î”ª»ri¸ÿO׋¤ëõc:˹›èNÒô]7&¿ò;’uD°‘%D+M(á|¸èÂÍv ',jL  3aL¬YáV~Ÿ_Ï8DzՑLCŘÓèT.dºr¬ðMå·òª/?º“c}×M€é1â÷ùy“FSƒ¾÷ºcàZcjLÃ^9ü]ùýš˜â%Í©h7Ѥé»nL~å·—b-rc^iÛ ¯‡3¤¬Œ‰R‹•ßG5Û̓QŠÓ¬ø­[pkÐ¥?Y¬ËÓè®\ü>•“tËÊOE»‰îäXßu`zŒø}~ÞISÀ‹EÒ­u ÕjV›FŒ ¿÷ÿôšfá$M _~ô6i®{Sô+¿A·bº™ÓLÏœôkx=¬˜T$&¥?²Ì˜²îxƒÍñÕ¿?Øöäüz&rLw”ì8>G¨¯¤Ô¦QÏ/%5WŽ Þmåâ©h7Ñë»îLñ9âwœ¿Á¤r”6såjÓ¨Ž ¾ê¦ý&iNE»‰î$Mßu`ò+¿!MòYeL)5âê\9Ã$A%]d³V>ØöäüzÆ9–A×¶bÑŒ¹ê`ј†Œ)¿Oån&ñP¼Ê¹ëèNŽõ]7¦çˆßq~à¥Xwi}¸®ünLC)|3¦WƒR/iÞS,«èNÒô]7&¿ò[Á!gÝÑf,KÝq_“PdÙº-W~ `d*Àœ+w~=ãËŒŠ² –hƒËScjLß· JJ7åñT´›èNŽõ]7¦çˆßqºí‰~„&$¦j5kM#Æ$ñ=WÎæ…ß$ÍÕˤŽî$Mßu`ò+¿£uÇÕmu/¡UÉÆ«k.@‰×ÄïãOÝõk`>©1ÅéÊoÝ•*õÓÝiªå‚Æ4:ù-ï»rVù}£1Å«œ»ŽîäXßu`zŽø§ÅïRb*ºå¨^6¦a?¦÷””„¯á—^Ò\ŠvÝIš¾ë&ÀäW~ƒbh´[¸ºãYíùmç l)DÑÍàê]¹b'˜„Œ|˜¦Ûž(†AR¶{ÎÎùScªMûrñ=W®ðíâwõ2©£;9Öwݘž#~ÇÙÊo$$&g(Mþ Li¨1áww¾éǬ¡¾üèmÒ \÷&ð+¿­úší®:fX¿‡õ%A"°¨1YW‚”¯±µcü$0ÁlÏïˆÈÊz…l“ù3ÇÓˆ1ey³rš{“cg#ï&º“c}×=€ ž#~ÃBÛkÄYII5ð²1ú1¥ïI¼IÀ¿Ä«¡¾üèNÒô]7&¿ò€…‰UIÖ¥[1-*E\Õ˜¬v9è¢Móý$0ÍŠßÌúâÛyšH]ÄÛ˜FŒ‰å{®ßZ‡àT´›èNŽõ]7¦çˆß0]ù‘õ•·ƒœR #lL£~Lø]c‚!Þ%ÍUÎ]Gw’¦ïº 0ù•ß3Ø]Úd¨º8WÎf´FhdSDWOå¢Mg‰Å*RË'ñž_ÏLŽQ8jÑ‚@}‰·1Nå2}OItS’W9wÝɱ¾ë&ÀôñfÅoeûÉêÉšdüdLiÀ˜øžßïŽráT´›èNÒô]7&¿òlîZ±xåî‹1ÙY|Q¾Dbqñ®\Ì9XÑ·.þøÑ­ÜtÏo› ,ºÏÕâטFŒ ¾uÌnÆÐ\¼ëèNŽõ]7¦çˆß0-~³Ý«}‰«rÆ4bL‰ÞûÿTn“æR´ëèNÒô]7¦›žß‚”ïèÞÊé95&eYúyZÙ8-žÊ)[RŠÉº-a]ý?ØZ÷üzÆ9–3’nÄ#2&ªÄïÆ4žÄó=íà¦\NE»‰îäXßu`zŽø ³â7[#3ý.Fò˜Ó€1åô]c’âÍN§¢ÝDo“fàº0%¿ò;*¹‹Q÷¤«ñ0½Æ” (ÍeuJŠè­‚ŠBHŸÜÊ¥iñ[Ý‹ÛÜR©ÅïÚ4ê`Aø¾+—oXyºí:º“c}×=€)=GüN³âwÊÂ@Rª€©1 “òšwå7ä»¶'éT´›èNÒô]7¦›žßœ¬·½²¼W'ñ‚Ý$eeA‰VOå¬_Š>n'ß9~²ò;ÍŠß‚ÁJØÐ—TOâ©MCÆÿèÇTnSJ_~t'Çú®›ÓsÄï4[ù@yN0ý¦P}‰·64&àw @¹©üNg9wÝIš¾ë&ÀäW~+UJA7¨ÄÊ&8æm/Xòzå7kî O¢rÍOÓ¬ømC—ì8ͶâUÛ“Æ4º+W¾sLB¼[üèËîäXßu`zŽøfÅoF]…9Û´j+W›Œ‰HÞ«™mÚo’†¿üèNÒô]7¦›ÊoLŠ ’¢bi\fLˆ!}Q-÷cÒíc bƒˆlÚÕiºò;ë¤l¤V%)­iØ ß9–õ¾É±«œ»ŽîäXßu`zŽøæ^–W6¨„ÉÆ4bLáûÄĺàÞ$Í{ŠeÝIš¾ë&ÀäW~G±X7rÄ‹Àôz¸ˆn•H?ŲÔöä˜d {GHºðCþ¨øfÅoN,œu¹JuSm1&HxåX±ãN?ÇNE»‰îäXßu`zŽøfÅoM`NÁþ)õ•”Æ4bL!¾OLb 7À„§¢ÝDo“fàº0áMåwÎÌÖ¥CHx¹ƒ¥Mb„V†¿:XZÙ=*ŠGþì©N¼Ä¬(]tm‘\måÓˆ1q~ß.È"7âðšbYGwr¬ïº0ásÄoœ®üƬÔ?L4=ð’$Å1Ùß?Scõü’ð=‰çU<âåØ5ŲŽîäXßu`¢çˆß4ßó›(%“ÿª¶'i°šák¸Ò±š…B7U¹ônä]Ew’¦ïº 0ù•ßšàl'ÙY¯jLÉ ³ñÃ,+#V,iôë/W±u#Ö‡oRé÷À4+~'ÂãZQ¨N~[Óhã»»ÜÓ©h7Ñë»nLÏ¿iVü¶=µ®dGÛ•øÝ˜†ŒIÞU¹1ÞÓ©h7Ѥé»nL7•ß¶1’sÌËŒIØT"ÝKHKWRìݵï€%£+|˜&Å~sŚ׋_mõüâüÖ11ó\@ôåGwr¬ïº 0=Gü¦Yñ[×dkÃn½ï뤩L#Æô’¦_Œ‰ïÆ7ùѤé»nL~å7ÚØ3²V¢ÇØ5Ƥ£(ˆqåHï8•Sj ƒ²K.GÔÇ€iVüH%£…롪­i8»ð»ƒ%Ù?ÇNE»‰îäXßu`zŽøM³â7)!Ž„)• ˜Ó`5KH׉ œej^ÒœŠvÝIš¾ë&ÀäW~ër^kÕªÿ]dLV»¥dÊéuw1%Ýb ˆ9eãø)`šn{’‚Bm´Òê˜ÓPc‚w½6ö^Ž]½LêèNŽõ]7¦çˆß4+~e!Án£q®» 4¦cJ¯Ÿ1…x'Lrøò£·I3pݘدüV0Œú# Z ¡5ƤënÎŽÕl'¸L…ôU’ióäØD~ ˜xVüÖo-Ç * ¬ïÊÕ¦c¢øfåÖþ&ÇNE»‰îäXßu`âçˆß<-~³.éJý%`ÕÄ«5 V³ãjÖŘ0Þ%Í¥h×Ѥé»nL~å7G%<˜K•ðzXq%)S´qéTN?.È6Zƒ¾crl"?µ•ãYñ;sd+ÈÂs êŸÀT›F³ _,éŘäî>&ŸŠvÝɱ¾ë&Àôñ›gÅoÝ]s–¨éœ¤*hLÆ‘®pW•˧¢ÝDw’¦ïº 0ù•ß\ +2(k2 {‘1éÃ%ç`œ«ÈB_Þ£\€³näì­µ ‹ŸÔ˜x¶ò•óZ6»þWÊ5¦c*ß=¿Ø Ûý;˹›èNŽõ]7¦çˆß<-~±á#ŒýWŒ©6Sxßü†Rä˜.E»Žî$Mßu`ò+¿sä’tš"Æ•^op>,úxÀ@a¥ýåKü>~¡¨kÆOÓ¬øm3¬LŒÇÌ505¦c|×Êé¶à¦VŽOE»‰îäXßu`zŽøÍÓ=¿A¿”usbS•[™FŒ)½ï1u)¹Iš«‘wÝIš¾ë&ÀäW~k~;S³¸Ú] Û-}SÄfñ.jLVœH™š•˜f+¿!X«…„VCÒ,~•iTù¿'ñÐÍÉ/Ë—Ýɱ¾ë&Àôñ›gÅo°QÒÑÎJ•ËVIS›ŒÉðãbL™ïŽró©h7ÑÛ¤¸îLÙ¯ü.‚¢¼‘ /w(ÊwâÿŸ»¯]’ŵ}žúq&@_ ÷±+9í¬]€ù¸Ž <=Ý=çH֮ʔ‹…¼ø öcbô{ÿ®RqŠ2¦4+~CDÛ+‰-.œÿ¼¨M#Ƥüí+o)vs*—NE»ŠÞȱ¾ëÀ”Þ#~§yñÛ¯¢±7bÓ²ø­4 V³ÓUcù>i¾Šv½‘4}×M€©]ùí­²m刓¬\wƒóa¿âR®– ˆú0õD¶›Fû³Ÿ¦iñÛ»‰dµ­8…˜*Óˆ1Qø]˜õæä7]Šv½‘c}×M€é=âwš¿ÕV!"¡H¡èù]™†ŒI¿§rƘn*¿Ó¥h—ÑIÓwݘڕßjiކ¦–Oå\ëO^ú- `±Q\ŽÄhP.F¹rzr+—æÅoôw¼ìã¯\P›FuLßI¼gcÂVŽ}í"z#Çú®›Ó{Äï4+~c ¶²æ¡º.P™FŒ)ÊWcòÙA7Is*ÚUôFÒô]7¦vå·ª+©rÜá…UÆdKÎÙ\RÄê¨cJF/Y¢!ÊáÉ+)iºç·!e0—lG^4Š«L£Ù…‰¿µr„|sÀ’®FÞeôFŽõ]7¦÷ˆßiVüöÕ9—½¦PÖ1•¦þj†šâ5ó RLwÓ©hWÑIÓwݘš•ßÐ8žú±Z^(E‚óao¥|dÕêø& ]d2†éEOÓtÏïìŽO»ÓbàEmÞ•ãoÝŠßéjä]FoäXßu`zøfÅïh$üRæü·Q|mê¯f¨˜®ý?U¸)°Ì§¢]E¯“fàº0åfå·%¸oÇe=Jo–“?¬ÁÏ­!]l{’5‡èmgì5Kòdw<Ýöl[E“Xø L•iĘòï}LB¼ÙÊå«—I½‘c}×=€)¿GüÎÓ/mË@f/‡”¦cÊñÛ$Ü]È×Ë2z#iú®›S³ò£Z’[2¾g ºÈ˜¢: qˆ–¶ráÞ޼ƒg üä©\žîùjî‘‘‹))•iĘòoK¿œy“cW#ï2z#Çú®›Ó{Äï<+~‘z›he²»@i0&{¯ª\¦»“L?íè¤é»nLÍÊoôF­‰ƒa„-ÃK/?‹ø-`Ì)®Þ•£”@Ïóïô(cš¿³ªí-}æ¹–å•iĘ0|+¿1ßõ•ϧ¢]EoäXßu`zøgÅïè½&“wI©¸Ä[™Œ)AþvðN7Is*ÚUôFÒô]7¦få7º"lrù{‘1ÙÃÉx“}Œ«ŒÉöo¨É«Aí> L³âwö³ û9Œ©2Nå·VÎÓ]w|*ÚUôFŽõ]7¦÷ˆßyVüÈloÐ!Óå•iÀ˜äÓN÷`L†"7Âd>í*z#iú®›S³òÛV^bõ!¼Q‚,žÊùÃ">8x³—Å:&/5HYìßOÓ¬øí $Úè=ÿ `*M#ÆäÛÁEî4¦SÑ®¢7r¬ïº 0½GüγâwÂÈ!¤ì:k±•«LÆdßë·ŽÉÞÊ›+)z*ÚUô:i®{“6+¿Ñ ŒA°HÊ ¥Hp>Œ1hÔ ¼ZÇÄÑçG o¡y #x ˜tVü&BF[^4SÑó«6 Sº†ªð­7À¤§¢]EoäXßu`Ò÷ˆß:-~{«#ÅDÀX\I©LÆdÞ×jì×´ÚIs)ÚeôFÒô]7¦få7‚¡‚_ÕÌ‹ý˜Ž‡•8úõô8ðÒ˽}¨:¢!GxRüÖIñ;GÌÉ;ÚS.~•iÀ˜$ðwv!ÄÛÅÚÑ9ÖwݘÞ#~ë¬øMà3íK!˜*Ó€1qþÖ˜a¾©üÖSÑ®¢7’¦ïº 05+¿ÑÙ’_¤EC˜•™•p>ìS| )g\dLQ$GŠ1ÙvðÉÊo¿ím×,Aí¡Bü®LÆ$ü;í8ÞÈz*ÚUôFŽõ]7¦÷ˆß:]ùm+º‹Êf.‡T¦cbøNâÔ|#LêUÎ]Fo$Mßu`jV~£wÌ^ŸE×®¤|–^ô§*KÀäR_Äà—žsð}‰=,OÓ¬ømÈl‰Hœ©¿+Óˆ1ñoßœÊé©hWÑ9ÖwݘÞ#~ë¬ø*¤Þ•̧^ÀTšFŒ‰~ë˜(Ü]ÐSÑ®¢7’¦ïº 0µ+¿Á~bãÆòr\½+wåÂÒÀËÿûŸ€d{*ºˆ›áAéüzÆ9–¼Þ6¦Q;–ý˜JÓèTNõ[ù rÓŒPÂ¥h—Ñ9Öwݘ^#~ŸŸ÷8i|k-ÉÇý¡÷JüL•iÀ˜búþŒ~ÙëŽf_S,Ëè¤é»nLw•߯vÔ6 Imi_®üfP#ˆÞ‡:-^IŽèserPz°òûüz&rŒ¼ ¹:£¶X¡c–¦còýíWc"n‹ßÎFÞUôFŽõ]7¦×ˆßçç=“4 >éÖVW[-Jñ»0 S€ß:&?ãh'Mü*ÚEô:i®{SlW~£×ªËÑ!ñjå·?ì{ ¢+Ó2Æä—äìN`{“üà]¹óëçXr¥Í($Ûf[¹Ê4bL ¿Œ)ÜæØ©hWÑ9Öwݘâ{Äï8ÝóÛçTú»“>ÒõŸî…iÀ˜|o~0ÁÍj¯FÞeôFÒô]7¦›Êoo¸™1å]‹ŒÉöÖ'!Æ¥ÙOcÛÅ¡æ~®<LómO0d^¼_žÊU¦cbýeLœn䂸íeRDoäXßu`zøgÅïäÊâ‚a1¾©2õW3оSRB¤ö=&‰§¢]Eo$Mßu`jW~GÌœmGI•Wë˜üaIiÑ‹SRÊÑx“”ôäV.NŠßöÓ `òyÊ©,I©LÆ„¢ßÊï7ý˜ šÚÑ9ÖwݘÞ#~Çé¶'¾LØ:¤€åQneê¯f¾Ì_•ßñ¸ØÞNš«—I½‘4}×M€©]ùÕÛnãñ[«ŒÉö*dñ.–«mO|·ã3£½·éÉS¹8+~ûÈ\ÃYD,SeÖ1á÷®\ÈG6´rìT´«èë»nLï¿ãtå7‰ŸL«‘’Tv°,MÆ”%\§rQ½P;i®rî2z#iú®›S»ò;‚xq%‰ýè+ÃtázØhO@/dZÔ˜rû”Œj±­ÏÓlå7’-*ÞÆ%kÑŒ°6SþÖÊcJw¬ü,箢7r¬ïº 0½Gü޳â7*£‚ˆ}ãõ•”Â4`LYò5%Å€éŽfCøiG¯“fàº0A»òûh ’ˆ2!­Œ†ƒóál¿uFoê´ÔóÛ“"{§"ûÓÕ ñA`‚Iñ;Û¯äZ~„ª$¥4¦=_Í]:ˆ7mOâO;z#Çú®{¼Gü†Yñ;Jï°‘½ßQ¹ÿ/LÆ”2]§r1'¹)~øiGo$Mßu`jW~Ût8>x—ê¼Ê˜üa¿ýkX,a¡aøÁ˜ ¥™â/1?Yù Óâ·×=`f56RŒoªLÆù·VN9·ÛžØþ÷§½‘c}×M€é=â7L÷üö)8ÞË̇¶ÿ¦Ê4`L å«1å»ÖºW#ï2z#iú®›S³ò4ùÐ"Ð+ àz˜BäýO+¿S–èÅòÉ{h†{~Ÿ_Ï8Ǽ¥Hô!\%XU~¦c ù{ò«!ÞåØo/“¿Ñ9ÖwݘÞ#~ìøM1 ra)Se0&Ÿ”{1¦”nZë œŠv½‘4}×M€©Yùm ÏÇ!3aʉ— ,χÉ5ìäe5kŒ)‘ý©ÞX KòRüiVüfM™ÄQ¶*(MÆ?gfášÂ~“c§¢]EoäXßu`zø “âwÊlä(/N…0Y™ŒÉ§4^Œ)ÉM¯ûêÚÑIÓwݘš•ß ˆ2€ÆÂÒ%ÞÏÇBdp,+]æÆDìùøDß'iºí‰}ƒbпĿ'¿µiÀ˜|*ÖŘl“|LW/“2z#Çú®›Ó{Äo˜¿Åö_Qí…÷ûèSe0&Êß{LQÞžŠv½NšëÀ„ÍÊo8nª˜@ûŒ†5Æd§¤‰D®¶Öµ·+ˆ‘%Iœ(<ɘp¶òÛK´9¢oɹ¸+W™Œ)äs3¦oÄo<˹«èë»îLøñgÅoÉŒ1Þü¢ø­2 SþeLn„I<í*z#iú®›S³òĶžÉe‹à›„EÆäã*UÅÞ¸Xùmõ[<>)‡ó“å8Ýó[Cð¾Éû-,¥i4»òwßÓÕÈ»ŒÞȱ¾ë&Àôñ§{~ÛýQ˞ߥiȘ„¿ŒÉ¹y—ÑIÓwݘš•߆-@à×B•`¥x·Q" Ø>0/V~“n´= ÂQ4ð$0M¼…ÚÖåå©\e0&{®Ÿ1ÞµÖ¥SÑ®¢7’¦ïº 0µ+¿}žGÛŠ‰¢.Ü*óaV姯¤à1R–rvÝüØ>L³â7{¡GN™ý’N±•+M£iÏŸãÏ´g’›:&âŸvôFŽõ]7¦÷ˆß4[ùm6Ì$†Rc*M#Æ¿SR#Å»K¼t–sWÑIÓwݘڕßI|¶›d/Â^dLö0e” @ˈI5©Ïh‰OXÒlåwb?‰'€ÂßrÚ4œ]˜/Vîíïrì,箢7r¬ïº 0½Gü¦Yñ;fÎÀäSÑ(®2“w[¼S¼ÝÊåŸvôFÒô]7¦vå7 ÞYÀ'Oêjï¦%¨Ú¾Æ˜l ™ü"¯@{Íž¦Yñ[’°&$ÍŠËÊ4š]ˆü­ü¦˜îÓ©hWÑ9ÖwݘÞ#~Ó´øm¯Ž ÷`ÓR˜¬LÆ8^U¹Ñvr7•ß|)Úeô:i®{·+¿½¹- ÉKº\Çd'–mç–Åy7½HÉH¥øäVŽgÅo ¼´šs L¥iĘø;‰×èM¾Ë±øÓŽÞȱ¾ëÀÄï¿yVüö®Ç-YoNVlåJS5‹G«Æ“1aŒ7«ŸŠv½‘4}×M€©]ù P9°øÂÕS9o™^¡éGl‹–Y’15†ášáÉî<-~³mN3zK‘²V®2 Åð­còorìR´Ëèë»nLï¿yºí‰Œ5"k/B,*¿+S5‹ªß 1܈ß|õ2)£7’¦ïº 0µ+¿#¨OQ"Éö×*cŠ~—}ìLÒ5ñÛ>®Ï¥/PÈ‘áä7yøßiºòÛ ÚkâçnÀ¿å¥iÀ˜ŒK~ïÊóÝâw•s—Ñ9ÖwݘÞ#~óüÀKH>]1D(¯¤T¦cBºº FÈù.i¾S,‹è¤é»nLíÊooÅ$ªšŽè"c²‡ƒ¿ð²6‰×¾£ZG¡seŸ¦é—}B‚Fû¥ ¹ 2¦=#\¬Ü’âî>&_S,Ëèë»nLï¿yVü¦@Þ)1G%*ïÊ•¦cÊ¿Œ >í¶ZIs*ÚUôFÒô]7¦v巊̶¡õÖ‹,ýác‚©Ñ¦ÅS¹ˆÌh(Nl¸ø,cš¿stþHò‡ãü¹+W˜FÓžãïìÂøVŽéO;z#Çú®›Ó{Äožm{âß¹äPÐìÚ4`Lé[ùmY“ÛI#g/“*z4×=€Iš•ßÑǺ'ÕUÉŽâýiµµn$Ÿf®h;àü 0ÉtÏoe¿·Ç®0—¬¼4fjú2¦ò\ W#ï2z#Çú®{“¼Gü–Yñ›³½b‹BYÇT™FŒ)|«rcÔ»îr*ÚUôFÒô]7¦få·`R/'“ÈçÊÓ›%Ÿü”Wª3ÆÄHŽ…šŒ¶så¦YñÛ~œÌö»D!*O~KÓhÚsúÖʥà +—SÑ®¢7r¬ïº 0½Gü–é¶'Á'ÃñqåV®0 “ÏæºS¼m{"W/“2z#iú®›S³òÛ øÎÓ°!%^ºÄûy88úÄ鲯$†L)æd Ÿ¦Yñ[Hئ4rq%¥2“À÷T.d¸Ñ1åT´«èë»nLï¿eVü6¢hT$U¹µiÀ˜Ò5ZÇÉÝjv*ÚUôFÒô]7¦fåwô:=6¾ãçRЋ–Nüáó0«ÃqŒÞMx‘1yag$¯‚Ê|´¨{ ˜¦Åïà—º“· ¯çʦѴçOGc‚»ž_éR´Ëèë»nLï¿Ó´ø­¶¬Æìì ñ»4 Û^îZÍ‚1㛤¹í2z#iú®›S³ò; g à´Wvcp>ŒoÙK¼:ð8”ǃl… Ó¬ø Fs¼ú–#ÃjÓ1¥o­œ¸cL§¢]EoäXßu`zø¦^¦”ÂuY.P™ŒÉpãê•c@¸IškŠe½‘4}×M€©Yù™|SàD‚+óà|8¤ïE¹Ú]ÀgÕ"Ž'Ÿßødeš¿ì#8FÝHÑó»6fJºº ÄüiØÊ±SÑ®¢7r¬ïº 0½GüNÓ=¿ÑÞ÷$TrQüV™FSøí.àh7Is5ò.£7’¦ïº 05+¿#‘ߤõi•1ÙÃ|¶\^fLQ¢¤àw1= L³â7ÙžR¼ÛH9W®2 ÛouåX tSÄ›NE»ŠÞȱ¾ë&Àôñ;ÍŠßÇ0jûº‰…þîÿkÓHcùÖ1…tw%%‡Ÿvô:i®{SnW~–ÚVÎHdHœ—F„䅒ȋݼ¬Bɇʠ}\O2¦<ÝóÛǽ¸X#Â+Óhå/cæ›S¹|5ò.£7r¬ïº0å÷ˆßyVüV/âó†d>¹&KÓHcÊú˘è®WN†ŸvôFÒô]7¦vå·a ¡Oܶ'[j­ûyØÍ öž¬öüNÈJÙ¶tjŸ'iVüæÌÉÇIh ,[ë–¦ÑìBýNI‰’ïÊò©hWÑ9ÖwݘÞ#~çYñ›mE÷e(©5&µi¤1!_U¹1ÜNâͧ¢]Eo$Mßu`jW~cˆÞŒI1X»’r<ì¿qŠGá÷ªÆd¬R|ª_µ{ôož¿“e@ô&Qå©\e1¦¨ß:&Á»r|*ÚUôFŽõ]7¦÷ˆßyVüfT Ù;ßk,ÅU¦cŠù»š\+iNE»ŠÞHš¾ë&ÀÔ®üCÓl$’1BZ½+gûɵí³Û"cŽHH9 Î> Ló=¿!©íLsÎÇrõ§çwa0&úNâq^x“cßFÞEôFŽõ]7¦÷ˆßyVüï‹ÑÖט*Óˆ1¸4&ÍŸ–¡‘4§¢]Eo$Mßu`jW~{# ÒÏÖ¶rÇÃÉo¥hÎ!ÁBk‚ƒ1q–ãÒ³Sƒ'» äYñ;©‘8e52‹Z¹Ê4`Lðwv!ß• äSÑ®¢7r¬ïº 0½Güγâ7"]¢9…¿ÀT™Œ‰.IóÉžê¤ÑSÑ®¢×I3pݘ´]ù}¨ß>¼ `y®\ô–é!‘o0l?·ª1ÛE‚æ ö˃À¤³â·2ûžÄ_ÿBÇ,MÃiÏ¿“xìÉIOE»ŠÞȱ¾ëÀ¤ï¿uVü¶¥9úFÉ›HÂde0&"¾V3%Íé˜NE»ŠÞHš¾ë&ÀÔ®üŽ`ûϨQŒÁ,kLöðq7ûœð¥I¼.èŸB¨wÁøä•¿³ŸLúy MÅEñÊ4bLœ¿µrœÓ cÒ¢]GoäXßu`zø­³â·%pª^ÄÁewÒ4`Lˆ_ÉGÁÝ1¦SÑ®¢7’¦ïº 0µ+¿}°kplòSíUƼÅ9q>F}.öcòw7qq!—øI`š¯üö†5â·ÿJ©24&£ƒ_ÆDwCUõ[Î]DoäXßu`zø­“âw²í—¡˜-ñWà/Í.MÆ„ù;%U}Üò 0ÉO;z#iú®›S³ò[U°$§?CÞò—1Kv‡Hy¢©`Là ¿íL%à““Ί߶ ô}¸ðß«LÆä;Œ)òMå·žŠv½‘c}×M€é=â·ÎŠß>À,Eñ6ìSe1¦(×Íï,ï€éT´«è¤é»nLÍÊo%´íxƒ;Hãj¢¿I£ÙpXüdqxÝ­¬üæHˆla|ò®œNW~  ŒhˆåÀËÊ4Ò˜"|Oå¼Xû˜®rî2z#Çú®›Ó{Äo¿“ë~¨ ¨ºÄ[™FŒ â5‰7ËçJJ L)œŠv½Jš‘ëÀ”ê¯Î“÷Ž›K)Œ%迌ÉÆli¢aƒ€ò®’m#Ev8¿žqŽÙKoH›(«_/.©0¦=‡üeL©]Ä›BüiGoäXßu `Já5â÷ùy“ÆVf²=GðŠ›P\I©L#ÆDñÚÿgŸ:qLg#ï*z#iú®›S³ò;)‰+Eš'ª‰þ&= Æ)Ù®´@·Ž~Lö°ø˜´JOv8¿žqŽ%²}­qÞìÛËâJJeN{þÕ˜0QûÚS g9w½‘c}×M€é5â÷ùy“&{ëzû+-*¿+Óˆ1}.ŒŒ)ÙÿqLW/“2z#iú®›S³ò;¡íåÒQªnÄii+ç£jÌYüšD^Ô˜¢mFTÐe\'‡œ_Ï8ÇŒéjгý¯Bü.M£Ù…ù÷TÚS —¢]FoäXßu`zø}~Þã¤ñjðQ”l¹ø L•iĘX¾§röRµOåR¸¦X–ÑIÓwݘš•ߢ!ûÄK™mC¶Æ˜|rS´½œ¢ÏË\ØŒ)y}‚󈼒r~=ãKêeYö%†±Ð˜*ÓhÚ3}kåüâÎÝVîT´«èë»nL¯¿ÏÏ{œ4ÙH,øtJªî1Õ¦c ß¹ò™ôVc:í*z#iú®›S³òÛ¶oQ|ˆ¢ß£¡áÙØ_Æ$Æ“0Eò¶L5&¯;ô>}.5ѳÓ¬ømøj+ Úö^¤¸+W™FŒIâ·»Æ[Æt*ÚUôFŽõ]7¦×ˆßçç=Nû¼=´1j*Nå*Ó`5ƒœébL~¤ LñT´«èuÒ \÷¦Ø¬ü–£4’#*0¤…ÝØÁ˜¼<‚ÅÖïl³Pkp0&À øÿÓ­ÿLq~à%!„”>*äV^˜FŒ ~dnX¦øbYDoäXßu`Šï¿ã¬øm¯Çb_³–ÀTš«@ºöÿ9ăf·€éT´«è¤é»nLÍÊoÈìûƒœÁ¸Ó"c‚èÕHt †Á¥­ÜÿýO…½×Ú>Pù€Ä›TúïÀ4Ýóí›3°ýH×¶r…iȘNñÛSÐö\¹¯FÞeôFŽõ]7¦÷ˆßqVüF&öÖÒFKŠ™_µi°šÅOs8_Í’ð-c:í*z#iú®›S³òÛ@T‚°íA‹uLö0È16%Ÿ£¶Ä˜lHœÀë;“ > L³â·-,–¶X)‡¿“xjÓˆ11}ïÊá]ËOE»ŠÞȱ¾ë&Àôñ;N÷üVÅ„ÑÞ!âJJe¬fñº`ioG:ÙS#i®FÞeôFÒô]7¦få7§ Œ–ìEÇCþ2&N¶€Eò–a‘1¹ä˜r dkÿ£À4=ðÀ'ûßåˆðÊ4ȱÌñ˘ïê˜â5ŲŒÞȱ¾ë&Àôñ;Ίߔ €†|ÈÕ†¦!c:¯¤8cÊ7•ßöÅÿ´£7’¦ïº 05+¿™í‡ö&–!®œøÃçaoÖéœB …#½Ccò–¼à×xYÂ1Wî1`š¿ýv:±¬Àbñ«LƒË5¦pÓÁ2EýiGoäXßu`zø§^†œ¼ìUôs‰äß~L¥iĘè;Á"ÙkyS` ×Ë2z4×=€ š•ß-Q0'oúǃº ÆDàÇšÇT·T*¶râµSÁ¶Òǽg{˜&˜­üì%·Àå}ÌÊ4šöœ¿,Œ¡çö%Þg9w½‘c}×=€ Þ#~ìø)†¬²½I…ø]™FŒ‰ø«1ß4ŠKp*ÚUôFÒô]7¦få7{¯ï ¶ÅñUÚ‚1… Ç@Iÿ//ì?­umíeÙÑ8€<ɘ`VüΆ°Ùïîæ¢\ 2 r̯L^ŒÉe¡`ŸvôFŽõ]7¦÷ˆß0)~'Mì-q1 ¦²ø­4 SþeL"wÀD?íè¤é»nLÍÊo߃ï¡áÃöd±»€=”é5£ŠkŒ‰$’ ‘KýA=L³â·$ÊYlg ¹¼Ä[™FŒéÓ_òØ|üL˜ø§½‘c}×M€é=â7ÌŠß–¼|\’µ¡ìÇTšFŒéÓ0â`L>Xþ˜NE»ŠÞHš¾ë&ÀÔ¬ü&I9y?¶Œ_cLö°Ï¤ã`ï‹}kŒÉÀ[$õqeLÓ=¿S jp©!C!~W¦ÑìBƒÝ/c G?Ó0]¼Ëèë»nLï¿aZüŽL)«os9‰·4|W33nÄo¸í2z#iú®›S³ò›Ž5ÈF^’mÖy¥æh€ŒÈ‹mO’Ï&'ïSŽ+Ólå·_ÌOR-YyiÍ.¤ø’âHn€IÚÑ9ÖwݘÞ#~ÃtÏob%û¶™$”uL¥i°šÅï©\Pº¹’‚W#ï2z4×=€ ›•ßdHjø¼ Ç¥rãa¶¿|зÊjÛ{½Ô§]("†ü 0á´øÌì3Ûb–r+WšFŒ‰ð˘‡•7€ /E»ŒÞȱ¾ëÀ„ï¿qVü[^¼E7Iq] 2 V³¾3¿ÄgƒÜÓ©hWÑIÓwݘš•ß$ÞäMünmE—Êއ)ûÍ’@¶£[<•ËäªV0¾%¶›|RcÂé—`?J.Vç¢À²2§=ÿÎ.Lù˜®)–eôFŽõ]7¦÷ˆß8[ù|fì•-“Ë“Ò4bLÂ×j&Þà˜Îrî*z#iú®›S³òÛÖlg?4ˆÂ"c:”sÛ ‡œ$¬Ð-gL)GCCV[ûÝÊá¬øÍˆ}8äbAm1¦ø­•‹¾/¸¦SÑ®¢7r¬ïº 0½GüÆéÊo'þÞîXŠ:¦Ê4bL˜®ŸQ¼Äÿ˜®rî2z#iú®›S»òüâ±BÌÇââ©xe%{JZz?d5Fu™ XàÑ­Ü´ø@À6JöQ9‰§4f¦ð«1Ý– à¥h—Ñ9ÖwݘÞ#~ãtÛ¿ÿ`/Q(öÿµiĘ ]÷˜Dø®ƒ%^½LÊè¤é»nLíÊï䃛¢­ééh´Æ˜R¤@9E&H¼x%Å{…‡HDšõÉS9œ¿EíïÞ)ª¿KÓhڳȷƒe@¾cL—¢]FoäXßu`zøÓâ·å°Øn)±RÁ˜*S5ÓL‰ÏQC‚’n]Šv½NšëÀDÍÊo‰ÄÞòmO†²¨1 ²%@ïkµVÇdo–_Ýñ!éƒÀDÓmOìÃ!¶”/*Ó˜1]ï3ô›K¼tõ2)£7r¬ïº0Ñ{Äoš¿ÉöÖNcÙïV[¹ÒÔ_ÍÔ¯ŒÀä¯V¼¿éT´«è¤é»nLÍÊoaô¹pÇŽjµƒ%=”LdA—ú1ýßÿŽ–ú®mÃøž¼ÄK³â·í(Á ,OåJÓ˜1]]R½ÞÍVŽð§½‘c}×M€é=â7MW~gR È^ š]šŒ é8~:ÞËs5kÓUÎ]Fo$Mßu`jV~KÖcˆàhV+¿íaÎGW¼ã:îrkÝ`/B ÁG·r4)~gŸûIâó$AË¥iĘäÛóËéŽ1ñO;z#Çú®›Ó{Äoš¿£¬c;Êžß•©¿še£IñdLÌœîÓ©hWÑIÓwݘš•߉mmWôó5Ê«uLö0y_Þ”“­à«­u]^Ò`û@ô›ÀOÓ¬øm{YŸyÐûLý]ü*ÓðTŽ®û˜~ |S.@§¢]EoäXßu`zøM³âwò4ä“n3[¹ÊÔ_ͼ ðš…ÍövÜiL§¢]Eo$Mßu`jV~m1¾$@ÇÿXì`™ P4zªè7rW1GH~÷+Ê“,iZüFor”½Ï[ÁÊKÓˆ1ÁçrøÁ˜Ü´=¡KÑ.£7r¬ïº 0½Gü¦Yñ›èdûAYù]™ŒÉ^#¾“->7uL|*ÚUô:i®{7+¿“w0Ú(˜#…ý>'È"Þ½$,¼?ÏõÏŠâ“uL<]ùíÏÁvI!pÑ] 2 é—1ü›»Ê¹Ëèë»îLüñ›§{~Ÿ× jßK9‰·2 \§r J7_¼Ëè¤é»nLÍÊïSdM~UyeÓ1‰×ö­þ‚ˆñ„ÅÖºàÓÉ£‘×ȶ;y’1ñôÀK´OíåÏEee0&Ý«“zŸî›»¦X–Ñ9ÖwݘÞ#~ólå7‹·4Ë‘¡8Ê­LÆ> Æ?´’æ,箢7’¦ïº 05+¿ìض@’Wì-öüÎ>‰ ȇ!âbw4ŽÆAmß›">Z`ÉÓmO²_ÚÇ ÞS¤`L¥iĘábLxÖ45rìêeRFoäXßu`zøÍ³â7G”€Œ¶õ€¢»@eê¯fI?m`?72l7r“4§¢]Eo$Mßu`jV~ûÅc#y¶C0xÒÅÊo{؈bðò̸ȘíË÷¦¼œ4ö1`š®ü¦dÔOm–Ê“ßÊ4š]˜å˘b”;V~•s—Ñ9ÖwݘÞ#~ótå7J2&’޾ØÊ•¦þj–l~iLÞ¯ún5»Ê¹Ëè¤é»nLÍÊooªr t,­2&ûú µç³_XcLD>"l7øhÏŠß²ý K(¶r•i4íÙäɘ|@óMŽŠv½‘c}×M€é=â7O÷üN”쟰`L•iÀ˜Äøðɘ¼þæfJŠ\¼ËèuÒ \÷&iV~û9ûüÚïÓ.2&&Û§ ½x^O¸Ê˜\n÷:&ñ(O2&™¿CVŒªAbÙ%µ2§=_§rö)Å›’¹í2z#Çú®{“¼Gü–YñÛ6I†"âÍ©SL•iÀ˜äÓ0ñØ ßÌ•“SÑ®¢7’¦ïº 05+¿sŠ1hrZá“=VSPÐŒ¨b¼g ˜||S$µ “¦'OådZüVÛæ‡”üvñ_V^›FÓžÓWcÊÞ<ø&Ç.E»ŒÞȱ¾ë&Àôñ[fÅoÛlNÉ6ÙÕ””Ê4bL!_uL”ÓÝ\9¡ŸvôFÒô]7¦fåwN@™r„èU¡kŒ)¨«öÁtkŒ‰ÙGÊkÛ†'·r2ÝöD¢zóZöá ©2¦=#^}åóÕ˜°‘cW/“2z#Çú®›Ó{Äo™¿Ñ/±ƒO^JEÛÓÚ4`LÌA/Æ”ñ®ò[NE»ŠÞHš¾ë&ÀÔ¬ü¶ŸCÄãúqN‹ÝœnAP?V“¥¶'~MQX½’OÝ|˜¦^fc!ÈÇè”/KÓˆ1™ëɘRV¸Ñ˜äšbYFoäXßu`zø-³â·oìëÖh/Bq©2 ùöídL†R7§rr*ÚUôFÒô]7¦fåw& tT8X®§¥K8gõ{¥>.3-5Š ÿ¢ä×¾Èï¸ò“uL2+~£Ú_ìýþ™þvI­M£¾ò‚W?&ž{SÇ$§¢]EoäXßu`zø-ÓmO’’ízcÁ˜JÓˆ1‰¤/c¢p³ÿOW/“2z4×=€)5+¿3 ÕW–æ)®2&ŸùdD1 ã*c²§AÀûòB¦')Ͷ=±]­_f>¦J:feMâ¹z~%L|³•Kg/“*z#Çú®{SzøfÅï ¶§öî÷šÊá•iÀ˜\U¹“ïCn’æT´«è¤é»nLíÊïìcÍA}ÆåÊï,Ù¡ETŽ׋SR8’ Ãò³/Ó|Ûo`®¾5År+Wš†ŒéÛÁÒ§ß0¦ôíeRDoäXßu`zø&Åoõ~Ú”Åç¾IS›Œ)ç‹1Ñg|s+i>Šv½‘4}×M€©]ùPüäYÕãµFqÇÃÞ•—5{‹‚¥a~!Þ‘ÄÚoñƒÀ4ßó›3SöiRÅÀ‹Ú4œÄ“¿Œ)æx—cßFÞEôFŽõ]7¦÷ˆßiZüfHöúÅR,·r¥iĘ Å/cŠtS..E»ŒÞHš¾ë&ÀÔ®üÎ^AìqÆ•ÆäV|rç°r¤w0¦ä#‹CLâ“WRÒüÀË̶íb¬N~kÓp}g†xW.¾S,‹èë»nLï¿Ó¤øÔÛÝçmuæ²si1¦L_‰?}ZI“ÚÑIÓwݘš•ßÞG)ÅHÑ+cV'ñª7Ê>šÏ‹3+¿“JŽ~(h+¿q€'iRü>†»å$‡¢µNe1¦¬WS²ÿãN.ПvôFŽõ]7¦÷ˆßiVü&Uµ=X_Úÿ&Meê¯fÂrŒœ=SÌts*—OE»Š^'ÍÀu`ÊÍÊo4e¢ˆ‹ŒIÅ럌.ù[Xj{âÊ9¨8¦±s€'{~çÙÊo?µðrQ£Ô…ø]›FSøNâMž79v–sWÑ9Öwݘò{Äï<)~«m7H‰æO7å5¦ÒÔ_ͼ2.ÆtÔß´“~ÚÑIÓwݘš•߉­é„^D±LÇÃÕ—ƒL\¸h÷™+'€¾0 Ûþä©\ž¿†DPûgJ%+¯L#ÆÒ5WN|š×MŽŠv½‘c}×M€é=âwžîù ¡úwŒúWcªMÆ”SúÞ•³×]Ò\¼Ëè¤é»nLÍÊoÃQÛy&ðÁæqm?LÊÈ)23…Å–~ H*˜¼»þ£­uó¬ø]f3*BððOŽU¦‘ÆôÛÁR„è¦\ ŸŠv½‘c}×M€é=âwžxIÉö‰©lW™ŒÉ/^Œ)J¾©üÎ×Ë2z#iú®›S³ò[m'¥!²÷×]eLHÞiÀû¦¬2¦€)‹í~m'ùd¹@ž®ü¶e*ùE™D%0U¦!cúÜÁü0&79v•s—Ñ9ÖwݘÞ#~çÙÊoö6®Ì–Å `ªLÆDJðÕ˜0Ü­fù§½‘4}×M€©Yùm…*ú<ܬ°ZÇd'HŸš{SV'ñfd{ ’Ÿí=Y.g+¿³Î eI˜Š»r•i0‰'åßIõíœ]hûû»»¦X–Ñ9Öwݘô=â·N¼Œ¶C Ê^§\¼,MÆr\ óÏ ýzûMÒ\S,Ëè¤é»nLÍÊoEQÉYàè°Ô(îÓ4Ö{P‰ÑDZkþgTéÏ%3æô$cÒYñ;“Úïáš™†’1•¦cébLpÛZWOE»ŠÞȱ¾ë&Àôñ[§ÛžDÈ4…\Sa0&Íq®f¶W7[9½z™”ÑIÓwݘš•ß~Ã?ÛO˶£Z,°<6t±Jô{v‹“¢½gÅà‰žÔ˜tVü&£€Fß”|4ñ_`ªLÆÄüeLᮈWù§½‘c}×M€é=â·N‹ßìÕ˜œ½9GÙ©4 SŒÇmÕƒ1ÙZ}Sc¢—¢]Fo$Mßu`jV~«×ÅÍœ„2­žÊ0¾üHuµ»‰Ï” )#=:WN§Åo!Àl8kX]Se0&Hpé˜b¼)âÕKÑ.£7r¬ïº 0½GüÖYñ’m­ÉõåOÏÉo~—¦c œð˘(Þ“z*ÚUôFÒô]7¦vå·÷Ýf—®ÙØËbÏo5ÆãÔ€½s ,jL@>;Ûøš•Á'+¿uVüöNÿÄ@Aƒwå*Ó€1ÅäšÄ£tËÊõ§½‘c}×M€é=â·ÎŠßQ²ÇÒö.ü­cªMýÕÌ6ç|õcÂD7SRr8í*z•4#×-€)×_ÝÁ˜R@ße–œ–.ñº’bD‰0ø¼KXAµcD¸ëR¶÷5B¡‘Õè`:¿žqŽ%û9D}@†²ò»2 “1Á«Vîs]§cg9w½‘c}×-€)‡×ˆßçç=Nšãº‡LÛ&©˜`Q›ú«K ×]9d½¡Ù9\Šv½‘4}×M€©Yù}4B̶›³Mè5Õj2i¢ÏmRû­£kßaþácà¥+îEد>8ŒàüzÆ9–H|qæÏ›¿Si0¦¾'¿ì>orìjä]FoäXßu`zø}~Þã¤É¶W°,¶Õ#—wåJÓ€1‰Ï’;“O¡½IšKÑ.£7’¦ïº 05+¿£Ÿ?ØkÛKú¼LÇÃ^è‡>†2¬“} 9FŒˆ”ó£À4-~0†£œ$–“xKÓ`ÚsúÕ˜l!¼]ü.E»ŒÞȱ¾ë&Àôñûü¼ÇI“1 ‹_dAʛߥiÀ˜R„p1&‰7âs¸z™”ÑIÓwݘš•ß ìo»0¦²È˜ìaÀ ¶”°B·ŽK¼³ï*$˜òƒâ÷ùõŒsÌï¡Ù7G^‘ʶ'¥i0í™c¸rŒIs»Ž)‡«—I½‘c}×M€é5â÷ùyO$MfÔàw„„sYcRšFŒé*pÆÄÚ®cÊáìeREo$Mßu`jV~û@9?CŒ 1PZdL>·«°ÏáÂ5ÆdTËö†JjÿŽo:¿žqŽíóà ?[•P蘕iÀ˜¿:&sâ»»z™”Ñ9Öwݘ^#~ŸŸ÷8i’rñ¯Ãû,3¿*Ó€1ÙîáÚÿ#Ü• ä~ÚÑ뤸îL±Yùmœ'£h&ðº 2|NªàÝyc ¸Æ˜b4,‹ÞÁD`Ø ê?Sœ¿ÐÛ 3{Cο9V™†Ó·¯fLNGŠÊïÊ4И2|?Löá”79v–sWÑ9ÖwݘÞ#~ÃtÛcýQx“޲çwi0&äï\9HxÓÁÒ2ë§½‘4}×M€©]ùmà)±}èR¹ÀçaBL!«þŽÄšLÉ>OΘzùƒ,ϯg"ÇbT=ºýÇ¿[¹Ú4˜]HΙÏ.©>2þ&ÇÒO;z#Çú®›Ó{Äo˜m{béåwàƒæ¿4»6SοŒ ï.XÂÙˤŠÞHš¾ë&ÀÔ®üNÍä$’2/œøÃù0…(чäºu´=10¢¬GiΓ•ß0+~}&Û+)¤TÜǬM£iÏ ¾“xŒÞ娩hWÑ9ÖwݘÞ#~Ã|Û ¾±öŽESeiL¶è|5&Ò›£\üö2)¢×I3pݘ°]ùŒ³ø2ºÚ]ÀÞ>£Y€G‹€åK¯ÛPðòq€;Xž_Ï8ÇìCpÒËÄòêõ¯ÆTšŒ)ê·ç·¡¿&<í*z#Çú®{¾GüÆYñÚfCýþbÙ] 2 “íZ¾Œ‰ïéT´«è¤é»nLíÊïd\‰1x›ŽW5¦Ä”sòçÞ sm+Ǭ€‘ Þ¼/ȃÀ4?ð’$x͇h.Nå*Ó€1¼>Lâ|'~ãwŠe½‘c}×M€é=â7ÎV~'²w>’½B.…ü¦ÊÔ_Íl•–«ƒ%Ä›{Lx–sWÑIÓwݘڕßÞ . í@mƒ°r«ädLFzì÷Ž uù¯=hÿõZÍOŽo:¿žqŽ%¿.ho¼knTÜ•«Lƒ.©Yñ˘(òÆ„§¢]EoäXßu`zøÓ•ßâ­¢m­mÛð˜*Óˆ1ñ÷Â)0Þ®fW9w½‘4}×M€©]ù-†ÌÇ4\Áuɶ‰b¦´ œå 1$4ÊÆ#Vþ 0ÍV~Ÿ ^+eoeÍ.Ìxxíi¸É±³œ»ŠÞȱ¾ë&ÀôñgÅï˜ÔÑxš¢smhL¾}ùjLFpn’æT´«è¤é»nLíÊo1DaãxQtùTŽlæÍK¼­õj¹€·5Èì%©)Ë“uL8]ùíãZl³`œ÷/0U¦cÈß¾òFoîÊáUÎ]FoäXßu`zø³â·‚ë ™l ÆT™FŒ‰¾/‘1¦›ñÍÆ•ÚÑ뤸îLtSùÍàã—Bˆ¶áX½+gG$µß7Ä•ễ1e#êý«IòxÄÊ&š¿Ùï$'%‡’âT®2úÊëWÇÄŒá˜èT´«èë»îLôñ›ÄoUõçZüþk1&<Ç7câœoöÿô«hÿÞHš¾ë&ÀÔ®üNàmKì{Þå~YcŠ~ Úx"…¸ØZl ”!'Ã¥ü$c¢Ù¶'¶ÉÏÑï¢Eà²V®4 z~ùØõ‹1% 7¬œÎ^&UôFŽõ]7¦÷ˆß4+~à7ÑÉ8lQÇT™ú«æßÕ ïZëÒ©hWÑIÓwݘڕßÙw>àüÎú"cÊ⓪÷D¿n·8Œ€£¢A8å!>ʘ&Åï(B‰Þ=9VšF³ Ó÷>&ªeÜMŽñO;z#Çú®›Ó{Äoš¿ííaÛ„Ù&;G¹µip*'®–€ïV³SÑ®¢7’¦ïº 0µ+¿Õ6R½:ÆK¿“=loH°Í +,õc²Þ#)&¢(a<ø¿ÓtÛ“ Þ9zýbѾ¹24&Lñ«1!½É±«—I½‘c}×M€é=â7ÍŠß¶Päl·.X2¦Ê4`LŒzQ£6zS.@ù§½‘4}×M€©]ùí7h)E£zF[V“únü0gïí±Æ˜0øK¦ÑðÜ»Ž? L³â7‚DÃZûm ñ»2“|QÞûUÝÓ©hWÑ9ÖwݘÞ#~Ó¬øÍâí.Q•Ë^9µiÀ˜ì+ýV~C¸»’Âá§½NšëÀÄíÊo¿?£†ÇM‡¥rÏÃHHê¥Èy±QFQòï"¨ >L<)~ç`©öCùðÞr+WšFÓï]9££r£crüiGoäXßu`â÷ˆß<+~£ß\ð«Ur9¾©4 “í.•"†ÆÄ§¢]Eo$Mßu`jW~«øÅ¾h›P¯YeLÞÁ’5 Øë²x*‡˜@%<ªåŸì.À³•ßF¥ˆd{DËI<•it*Gù«1¥|wQœÏrî*z#Çú®›Ó{Äožîù …Ù—fùK³kÓ€1¡Äï©\Pº¡Ù|5ò.£7’¦ïº 0µ+¿³ítü:Yd‡—EÆdÛ™Ž1Ÿ‹Œ 9z/öF1#àÙÊïlÉ ¶nßÁ²ƒeiÎ.ü꘼w]Rù,箢7r¬ïº 0½GüæùžßÁ¯UŸ9Q\â­LÆ„¿=d½°ð.i¾¼‹è¤é»nLíÊoÛL'”°tÝís*çyý`OlïºXùކɓÛnZôÉS9ž¿}f â1°l­[™F³ ã÷Ãô¶¦wŒ)ý´£7r¬ïº 0½GüæYñ½_>ûŽ¡hâU›FŒéRy1ÉÝ”>í*z#iú®›S»ò;[9Ÿí'«•ß>|! Ây±µ®ËS!i´+}¦C<L³âwLHކÿTSe0&Býö•'¾Õ˜NE»ŠÞȱ¾ë&Àôñ›§ÅïC$ £µXÁ˜JÓˆ1qüeLùîJŠ\Šv½NšëÀ$7•ßöS»TkŸ ®‰ßÇöã@b\+ðVXÇS ¶ú§I¦^2goåé ”ŠS¹Ê4`LÑßžŒ ÒÝø&¹¦X–Ñ9Öwݘä=â·LŠßɧհßb;‡bÿ_šFŒ)çëæ7Ø‚}#~ ü´£7’¦ïº 0ÝôüN”’<“áõ꩜$ôNÂ/IW+¿‚Fû2B²ÿõ$c’é¶'ÙÚ(´×Ç9V™FÓžI¿•ß é˜®^&eôFŽõ]7¦÷ˆß2+~G¶—=g?/;XV¦c‚ømUù¦ò[NE»ŠÞHš¾ë&Àt×óÛÛ´Ù® â︽©¤9ô®Ì>*eñ®œ}òÀ¶ùµŸ …'§¤È´øí·÷4yL±hW™†Œ ¾wåì7¼[ü.E»ŒÞȱ¾ë&Àôñ[¦{~#€÷­gÄPŽ/MÆdØq­fQãmÒ\¼Ëè¤é»nL7=¿ES8¶sKÀt<œ“ÆlH/aåáOwñfÄ1P éÑI¼2+~cFµ_Ä»°•Œ©2 SøíÇ„G§vŽŠv½‘c}×M€é=â·L¼dûë¸ _ŽÖ)MÆô{¯Ë€éî“\S,Ëè¤é»nLíÊo¯½6h8º1å…^oƤÁpE¡¼V.`W°]‰1®$ÆŽ#¬Ç€iVüF²‚­0¶+€©4¦=+ý2&¸• NE»ŠÞȱ¾ë&Àôñ[fÅo$ô®>"³dL•©¿šÁÙ0ñsZÎwã›Ó©hWÑ뤸îL©]ù-LÁxO"[ŠeYcbCydZk{â5ˆ$ú­T=Z<>×Á2M·=ÉG©‡·Ô*çÊU¦Ñ´çøeå>ææä7]½LÊèë»îLé=âwšn{â Eô)Cʶ'¥©¿š±ìë ôV%7Œ)]½LÊè¤é»nLíÊo¯µÍ%ËöµñMÇÃø©ƒJ!­Tg~NålÝ÷›zIm­›¦ÅoðA•l‹KJEkÝÊ4èù•ñ;5Æò!Üè˜éR´Ëèë»nLï¿Ó¬øí7 ýr]Ý] 4 Sfþ2&ot“4§¢]Eo$Mßu`jW~‹ˆ«{»ßB.(MÆôχií]ktN±¬¢7r¬ïº 0½GüNӕߌ ’üëˆZ$Mi0&o@t1&ùôšl%ÍUÎ]Fo$Mßu`ºéù$©MSZ¿‡Y²QGX¼Ä{ÜÏSÌ9(…'iVüf€„Á¶¦TŒ¯L#ÆtœºtðMÙʱSÑ®¢7r¬ïº 0½GüN³â·í8ƒ½A¡`L•iÀ˜„ÂWc„›Õ,ŸŠv½NšëÀ”o*¿Cò*ñ)ÂëuL>X(؆t±Q\ôž¼è›ùì“|<•˳â·ScÞ“Š:¦Ê4`L–+7 n4¦|*ÚUôFŽõ]÷¦üñ;ÏŠßÁ‡˜ý·4+® Ô¦cbúeLán®\>í*z#iú®›ÓMå7*º2F~»dµç·ÑÈâ=,‘dqàedŸ•l£C1>Úó;O·=Ñ ì­|ÈBÁ˜JÓ€1ñU ïÒí nrìêeRFoäXßu`zø§^ÚÊj«Ù7ŠFñ•iÀ˜\›¾Ó1Úº4×Ë2z#iú®›S»ò›…cÇø& Õ–¶SoÏÁ e•1%åì*'üì{¦ùžß °ê•èe_ùÒ4`LhtðbL‰ïú1åo#ï"z#Çú®›Ó{Äï<+~#&ö{ìtðþ¿Si0&"câ 7åY~ÚÑIÓwݘڕßF — …¤º‚-c⬾óV¯ºÚöìéüiÈèóxŸ¦ÙÊïäÐ;jªVå¥iÀ˜Ìù:•ƒ$w/òYÎ]EoäXßu`zø§{~SLš0E.¯¤”¦còvnc"¹F˜¯FÞeôFÒô]7¦vå7+€Šmä8 ­jL†j12äHyqà%¸^NIl ˜Ÿ¼’’§Åo£€€ìý‚‹­\i0&øgO p—c—¢]FoäXßu`zøgÅïDà9ØUœâT®2 €\Œ‰èîÄDOE»Š^'ÍÀu`Òvå7‹½¸~/Ï•c?‚´M‹Šˆ.jL ^g€Æ~r+§³â·x7M”„~¸ú˜*Ó€1¥o_yNwÍõT´«èë»îLúñ[gÅo†h›j6ŠÑ:µiĘˆñ˘讵®žŠv½‘4}×M€©]ùͲ­ï!bZ?•ãìšÞ¹Û6‹—x!‹—|!ó1^æI`š¿Ñ;j¡mÄ…K`ªLƒû˜¶Å½¶¶àM‹or ÚÑ9ÖwݘÞ#~ë¬øm 6GÌhÛ,‡”¦cb/cº½+§§¢]Eo$Mßu`jW~³­¿(®Y ÄÕ:&VkÌ9%Y,ðºCû°"e2ÒFOöcÒÙÊoÌ  ñHUSat°È¶I½Å»îÊ?íèë»nLï¿uzà¥f@ÌjïO)~W¦câøcº¥Ù×Ë2z#iú®›ÓMå·Ðö ¢¬žÊù¤Jò«î‘/ Ú§µ.ddÛý¢›>Y. ³â·íe%8Á±ÝR©1•¦cJø;‰IîÓ©hWÑ9ÖwݘÞ#~ëtåwôÖAàã ´(°¬L#ÆE¾Œ èŽ1]åÜeôFÒô]7¦›ÊoÃfTa²íÁzSô®{Y„ì=YÔ˜|²xã“@øiõ0MŠß9BôbSÈ)PQ’R™FÓž…¾•ß wÃTÚÑ9ÖwݘÞ#~ë¬ø )1û6$cÑó»2 Ó?#gã1Ê©•4NE»Š^%ÍÈu `Òú«û0&òYx¶@€÷ÒXeLDä9#>²ZÇ„®J;Õ²½ <9‰÷üzÆ9–¼*Ò[„iб,°,M#ƾŸ wàkçØÕˤŒÞȱ¾ëÀd?ä[€éü¼ÇIã“M CPS1W®6 “×g_Œ ÛU¹>Šv½‘4}×M€©]ùm´Å>ŸŠK¶—[Õ˜üú¯CKö¡z‹S6ÌÈ1> L³â·dûU¼i9¾©2 ¥|u°€˜C›1i8í*z#Çú®›ÓkÄïóóžI##ÄÅ (rKÓˆ1Á·ñ1¦›ý¿úiGo$Mßu`º©üfö¾†Õ)ÃÒVîxØvGù…½‰‹Œ dv¢åäB<•;¿žqŽeç¼C²µ…ŠkO•iÀ˜ŽÍüɘÀÚ9v–sWÑ9Öwݘ^#~ŸŸ÷DÒxËüäå‹h¯Ðߤ©LÆäUýc¾i{¢áT´«è¤é»nL7•ßǽ[ Ø6e˧r‘Àv­¨”ÃzS”x›÷Ö}ðTîüzÆ9æM‚Õ; @*¿Ê4`L „_)È]ŽŠv½‘c}×M€é5â÷ùy“&£då¬Þ —‹Õ¬2 S€ïœ¢xÓó[Ã¥h—ÑIÓwݘڕߔYz7¦´®1yÁ¸ú8‚"-“ׂ&Î1Æ+¿Ï¯gœcÉØ. !ŠQßB.¨MÆDú;»0fº¦«œ»ŒÞȱ¾ë&Àôñûü¼ÇI“ŒxÇ ûJly.ÄïÒÔ_Í¢ª|+¿Á¾åvÒÄKÑ.£×I3pݘb»òÛ¶aÙži/µT‚ÏÃ^èî÷ä”Vª3ÆDÔþ`ñÚŠßqRü6x5xÎâÛR*N~+ÓHc‚ß~L^êu“cñ§½‘c}×=€)¾GüŽÓ=¿]Œâ׳Êýeê¯fQÃ÷ ŒQèFüŽW#ï2z#iú®›S»ò›$‰oÇŒ½®V~û‘\Û·d•´|WÎý>‹…Á¯¤œ_Ï8Ç|I±Ÿ)gõY$Se1&üÖu}ÆwÀômä]DoäXßu`zøg+¿Y?: TåÖ¦cÊôÛ)ÂMw{]~ÚÑIÓwݘڕßöS£ƒ©b^fL^ÕÌ(àÒ$ƒƒ1aßzu'%x˜f+¿mÎŒ>PYËFq•i4í™âuòë§ûí"^g9w½‘c}×M€é=âwœ¿YsÈ1Ú. ‹a„µiÀ˜¼Yã—1ÅÛÕìT´«è¤é»nLíÊo4þÄáÖ» `ÎÉ{¼ø{«#ÂCRÛA2‹‘V|°ÀòüzÆ9–¼µ)é‘ËÖº•i4íÙàèbL!Þ\{Òx*ÚUôFŽõ]7¦÷ˆßqVüND œW¡lWšFŒ)þØBº9Êù§½‘4}×M€©]ùíeLY|¯ðÊ­ø<Ðo\z]ébK3Ÿý2Úý¤øgÅoÛYfPŽÁg#[¹Ò4šö¬ñÒ˜¢B¾¿ã©hWÑ9ÖwݘÞ#~ÇIñÛg¶‹—Ú`Ʋ‰We1¦@ôeLŸ!8¤ðÓŽ^'ÍÀu`‚vå7y]h4Ž— ]–¶rÇÉ•Öe/v°´—˧m&*OL·=!õ)Í’s,·r•iÀ˜¢í¶®S¾+€«—I½‘c}×=€ Þ#~ìøMJÞ½)$.ú1U¦cJñܳØÛl¹¿IšSÑ®¢7’¦ïº 0µ+¿É¹ @éò]9ƒ•.”"ë¢Æd}ô¤‡G·r0+~pöèSÏcø+Ô¦cbøeL!ÞhLp*ÚUôFŽõ]7¦÷ˆß0+~G¿áÆ@jkE¡1U¦cJÿtrG³~ÚÑIÓwݘڕßxð'"Zî.€œÉ/n±mVÖ^ÃjÍî-±?ûž‡Æ7_Ï8ǡƄÞÀ´`å•i4í¾Ý¼ŒäæJ \S,Ëèë»nLï¿aRüv¡TÁÖ *&ñÖ¦!câÓÝKø(ÚuôFÒô]7¦vå72'¦” ‚¬´íþhLLÞP8rˆ«â7@`¿ðœìùÁI¼ç×3‘c ¤!§@ ñ»2 nh ß3nssò §¢]EoäXßu`zø ³â7øTÆœ¼kÙó»2 “ˆ~W3ãÄwŒ)ÿ´£7’¦ïº 0µ+¿A}N ƒß Ä…R$øžª LÚÑ9Öwݘð=â7N÷ü¶Ô÷Ñ;ü¦Ê4`Lü;óK9³[Àt5ò.£7’¦ïº 0µ+¿!Øë¼ÅeèÕ»rp\u#oÙ¹x%Å‹ ‚xã[!’;Xž_Ï8Ç {«`Ÿ(Q”¤Ô¦cJ‘¾§r’ïNåðjä]FoäXßu`zø³â7A@Ê`Ësq*WšŒ‰ówJŠ Bº¦SÑ®¢7’¦ïº 0µ+¿ Y\ªÏÂIp ˜Ž‡}Ú%Úþ•/ñÚâŸ!"Î> LÓ•ß¶?²x•cµiÀ˜$Æ/cˆwÀt•s—Ñ9ÖwݘÞ#~ãlå7%Ï_’`„§¦Ò4dLßhêHo€é,箢7’¦ïº 0µ+¿ã1WŒ³ÇU)ÚK§)Å$‘tIü>®ù0ÃÅ£ÿÉ“À4)~û5oóï 2—cèKÓ€11|/ú«›û˜˜~ÚÑ9ÖwݘÞ#~ã´ø‰½m~¢TNI©L#Æß¹ò ùsšÔHšKÑ.£7’¦ïº 0µ+¿£„p|")¡®Þ•3ò‰!&cN°tøl{Âà]æP"<9"üüzÆ9–l‹ïûÚìmkÊI¼¥iÀ˜˜òï´ç¤7uLx•s—Ñ9ÖwݘÞ#~ã¤ø­þ—3ý¦Ú4`L”¿ÛެçÕ:i(ü´£×I3pݘ¨]ùm  FòŒ6ß[~<ìÍ‘1;ïâ%ñûx‰‰‚·çeÒ'+¿iVü6nC~G',JR*Ó€1Ñ?· (ßµ=¡SÑ®¢7r¬ïº0Ñ{Äoš¿½Y~JÞþGËî•iĘR¸ú1+˹&øiGo$Mßu`jW~e#>¶üÚÏÍy‘1¹~cK8ûÑÞ Ý:“­ú(A¼#qzô®ÍŠßšÁGÝæ¤Ÿ¡^ÿÖÊ•¦c²µé·¯¼òMŠv½‘c}×M€é=â7ÍŠß>zÄþ釥eåweiLü­$T¢n€éT´«è¤é»nLíÊoW‰ˆ YŒ6Ájåw?º6œGV\x‰Ñ¶%Rò)åOÓ¬øý ÑV–¢À²2f†ðíùE€7ʼnÚÑ9ÖwݘÞ#~Ó¬ø’—äIQcR›ŒÉv[_)ÜÓ©hWÑIÓwݘڕß^-†Lö¡$Yj{â{Gôn ð9X[ßdè­jŸVLø™ù0ÍV~“w¦Jhß`Á˜*Óhv¡ý±c¢Owî0åÜUôFŽõ]7¦÷ˆß4ÝóÛ5¿(–ÎQ‹a•i¤1%úÕ˜nê˜èjä]Fo$Mßu`º©üÆ£%0fo$¹\ù Þ¦˜3aÊk“xƒÓqqþäÇ€iVü¶¯ÈçocÀb®\eMâ¡ïÈ™ˆ™ï€éT´«èë»nLï¿i¶ò›í›ð»U‰|ÊÐßËÒ4bLHcÊ’ÒÍ©ŸåÜUô:i®{ßU~£§`ön¢«ý˜@À-d±ýØÊˆ•ƒ19J:F]¢?L<+~ûøNûUœcÉ_¹ 64&ƒû¯Æ$w§r|*ÚUôFŽõ]÷&~øÍÓ•ß IÁwKf(€©4Ñ¥1å„|#~óUÎ]Fo$Mßu`º©üN1dV°dW]&X4Ú£l»AåŶ'hûïZDÞúìÑ:&ž¿ýö¥)…¢çwe0&û;“xŒ“ÞÓ¥h—Ñ9ÖwݘÞ#~ó¬ø ^!ì£ÅÞƒ¿ÀT™FŒ)~kLŒdëÍVŽOE»ŠÞHš¾ë&ÀÔ®üFŠ‘lG~Õt¹ƒ%*„hûa/®YeL(k~%UcÎOöüæÙ—!xwª@$±h­[›FÓžI¿•ß|Óö„ù§½‘c}×M€é=â7Ï‹ß!¸ÈÊ©(¨LÆ„ò’’m#"7ÀôU´‹è¤é»nLíÊoò“5â(9“®Ö1Qô1®¨…¼B·ÆÄA0¸He|MŸßÄÓ=¿}ÂÍqmß~ª¿Œ©2SJ¿Óž)ÞT~óÕÈ»ŒÞȱ¾ë&Àôñ›gÅoÛ$ ÚbeÛ“Ê4`Lß¹òÙÞÓ©hWÑIÓwݘڕßd;¹dHòžßËSRBÎh[cï½ EPc²\¶ €7Š}”1ÍŠß‚öåHº_œÊU¦Ñ´çgêÝ]9>í*z#Çú®›Ó{Äož¿½müÐöØ©xY™FŒé·¹µ—Ý“œŠv½NšëÀ$íÊoC•l 0Ø'±ÜóÛ¸@„$8‡Å:&ôË;¦0ºFõ 0É|Û?#T–‡å•”Ò4šöÌá:ùõÎ27“|{™Ñ9Öwݘä=â·ÌŠß¢9b ¶ÝÐPhL•iĘ"_Œ)Ù«A7Àt*ÚUôFÒô]7¦›žßÞEÚ§(‘+YeLb¿°éòr¨%ñÛë˜ûð'ö¹2Ε“YñÛ6ö^Æž½“`9ð¢4¦=gùNâñ#º`ŸvôFŽõ]7¦÷ˆß2Ýó;h:š- cL•iƼÕéç%J>U혮FÞeôFÒô]7¦vå·ý¸9„d´ÅHÓRkÝãa•‰àöj(©ýÉüª^~²\@fÅo /`$6(“ò¢xi1¦¾ÝàÓ·LüÓŽÞȱ¾ë&Àôñ[fÅoÉHÊ\ŒÖ©MƒÕ ð,Ø1ÆDn:XÊ©hWÑIÓwݘڕߒÙÛŽ`´Ÿ}¹ŽÉñÛ»ã®vH!%ßÏ!K8(ìcÀ4+~{ßÛä¿rAmiLæýeL|w%ENE»ŠÞȱ¾ë&Àôñ[¦Åoð¹gík.^V¦c‚ðS”À(Î 0]Šv½‘4}×M€©]ùlöƒ9xã"cJ¶ ¬œIaõTÎH%ð”m yLË| ˜¦ÛžÇhJˆT°òÚ4È1CÃ_ÆîÆÐËÕˤŒÞȱ¾ë&Àôñ[fÅïÀIJ_t+û1U¦c p­f.%ÞÔ1¥SÑ®¢×I3pݘR»òÛ ¯¢†„ ”W» x_zÉÐ8 .vÐl#Çè[W·žx™gÅo¶¯/Û¶4•Œ©2Sˆ¿ŒÉkåšÀ”OE»ŠÞȱ¾ëÀ”ß#~çYñÛeRŠJ(åÍïÊ4bLDWw¹›+—OE»ŠÞHš¾ë&ÀÔ®üÖd z’ÌFšÖ“䤙ì[d ‹=¿½ª"D:  àÉI¼yVü6–#”SÎ ¹<•+MƒKü[ÇR¸¦SÑ®¢7r¬ïº 0½GüÎóâ·o[kËl)~¦cÑ/câÏÿn$ÍWÑ.¢7’¦ïº 0µ+¿í@û;F5¦·t%åx8ˆƒŸb/ ¼ ÿK˜¯çüƒð0ÍŠß¶OòãEŠÅ\¹Ú4ȱßò‰˜oÄï|*ÚUôFŽõ]7¦÷ˆßyVüŸ¨ÈçÜ3¿jS5SÅ³ËÆÿýýÉ 0ÉO;z#iú®›S»ò[)kñËÇB²Ú]@‰R`?̺ʘ„m'‡Œê]yÙÓ¬ø"G û±|\^L¥iÀ˜,䢀nê˜ò©hWÑ9ÖwݘÞ#~çYñ;úÜÀ”½_.Nå*S5Óìm(>Z«QºÓ˜NE»ŠÞHš¾ë&ÀÔ®üöžÝÎâ£å`µŽI…D1T º6"ü «†äÙÅï¸ò$0MŠßFÿD¼UÂÑžª8ù-MÆ$‰¾•ßáöoÖŸvôFŽõ]7¦÷ˆßyºí‰‘ö²²ø™ÿ¯ÆTšŒÉK/ÆdÈtØôêeRF¯“fàº0i»ò[“×Ådo°\Ç”¢÷ à·yçHfÎdÀćrþ0é´ømÄ/ûø \Ô1U¦!c ¿Œ)æ›+)z)ÚeôFŽõ]÷&}ø­Óâw"ðomÏPŠß¥iÀ˜¿—Ùm÷ŸnÚžè¥h—ÑIÓwݘڕßú)&ò~ˆ¸6¾éxØ»P¶‡UñÛ>ztQ íήP= L³â7‡ÀdÜQ£'¿µiĘâ·ç·f¾x¡§¢]EoäXßu`zø­Ó/¼ dÛ]kQcR›Œ)~j—ÆD9ß1¦kŠe½‘4}×M€é¦ò;Fo|nPàµK¼þpð;rJ¾ 䥭Üÿý„ÁïW°z3> LÓ=¿…ȶHDÕPÕÒ4bLálne ¡ô¼É±«‘w½‘c}×M€é=â·ÎŠßhé¯HÅ{NþIšÊÔ_Í2«|5¦ˆé¦ç·žŠv½‘4}×M€é¦òy’ ù±Ü*cŠKìÅ„V'ñRÿΕ+MÆÄ×dcLé.ÇÎrî*z#Çú®›Ó{Äo¿S¶Öh_·½ûeÛÓÒ4`LturåÚ\Í¢ýýÓŽ^&ÍÐu`ò²É˜²·![“úQâbw=ÆVïZî`)HÉV}ñK)é9éúz&rŒ½™¶b¬^V¦c2ÿëóP<‹-9öU´‹èë»îLþC¾˜®Ï{œ4™9«—T‡È¹Ð˜*Ó€1’Kc"o+{“4×Ë2z#iú®›S»òÛë¶ÙÖ‡È!¬‰ßÇÃÂâmdcJºx*léh|ÒÊ“À4+~'ŽIƒ}" K`ªL£Ù…×ça ¡*7ïcÚOv*ÚUôFŽõ]7¦·ˆß×ç=Nš}:"û5Y)Ç7U¦þj–²Ò¥1Q íûÉ®FÞeôFÒô]7¦våw&ŸR’÷FZi©ôaL®Âf¿JÏqå>ËÑ]@]õV±oÃö=Ïm宯gœc¶ 'ŒŒö¦êoiM{Nßêö ¦æíûÉÎrî*z#Çú®›Ó[Äïëó'M6 Ù– {…¨¦ÊÔ_Íå‹1¹ð{“4òÓŽÞHš¾ë&ÀÔ®ü6Æ’-ÕSñIÖkŒÉ‹¶ùèÉ´>Wü@ŽlçkÿÑîá1`šx™ŒŽ'©2}{~e{îŽ1}§XÑ9ÖwݘÞ"~_Ÿ÷8i²ˆ­;³ ¯¤”¦c WûBmß•³Ÿìjä]Fo$Mßu`jW~ÛÏœÕóÝà‰WOå ÌÈËI•ˆW&ŒÉ¯³¸üâ-†ä¹K¼××3αd[ZLäC¸ýVñ_©4&ñü^ÑñqƒwrÁ©hWÑ9ÖwݘÞ"~_Ÿ÷8i²‘‘¶íˆ9äâoe0&¼ ,1yËÉvÒijœ»Š^'ÍÀu`ŠíÊoF¯ë5Xŵ—ÇÜb´“®5гõm…8Ä)¯fö7—¦8+~ëq€ÁgÆ,•i4»ñ˘Bn—¤ØOv*ÚUôFŽõ]÷¦øñ;N¼µ÷ž½Oi,/ñ–¦cŠ™¯Êo‚t·•‹×Ë2z#iú®›S»òÛ6"Ùh^¦W§¤ØKâó@l3†iå¢ÝQù­HÙ1ñKÍOÓtå7i„Èlm)¯¤”¦c ßSʤF+orì*ç.£7r¬ïº 0½GüŽ³â·øü\¿¸ ©2 SÌñ«1Á9Í¢‘4§¢]Eo$Mßu`jW~£m>#ƒxÛå~Lh´Ç›PÛn xÕŽ~L2dLÞñLŽ ¤Ó´øÍ1A4¨$¯cÿ+~—¦Ñ$žë$Á©¡r³òÛ~²KÑ.£7r¬ïº 0½GüŽÓ•ß¾¹ŒHÞÚíoei0¦ÀzÕ1yW·›ý¼Ê¹Ëè¤é»nLíÊo$ Ì(kÃtÆä×ììQ¥¤+7€)dã–l«†ç®¤\_Ï8Ç Als*äK©0f] Òwª7'¿ñšbYFoäXßu`zøgÅoËáàƒp"jQcR›ú«™hü­cŠ·åñT´«è¤é»nLíÊoôþö‰r/Ã_eL‘ÀpHÅ^™5ƽ¾d—¶ÂGè{ ˜¦{~'uîhÿR.‹xKÓpv!_wå’mWoNåâÕÈ»ŒÞȱ¾ë&Àôñ;Ίß~®í¯¾mbÙ©4õW3IDßS¹pÞñª“NE»Š^'ÍÀu`‚vå7øLó¤Ê«uLsâ`¼€k±ç·­ùNš¼ã·L}˜`zà%Ù¦V£f .ËJÓxÚóõy$Œp£cÂ5ŲŒÞȱ¾ëÀï¿aVüÖÁo‹ú®˜*Ó€11ÐŘÐOÒn’æT´«è¤é»nLíÊoð–f˜²_WO«ÝÀ芡» 7zY¼+Ç%{%3?y%fÅoȶ¦#AÆ‚1U¦ÑìBÒo_yoz“c§¢]EoäXßu`zø ³â7k¶mƒo8Êa„µiĘ@. õö(NE»ŠÞHš¾ë&ÀÔ®üŸD`Ä%§?‹Œ "Ùf\}KòbÓ÷¼%È“•ß0+~q³Â+ÒYŠS¹Ê4ê+o›úóóð}Wó¯ýd§¢]EoäXßu`zø ³â·ån ÞÕ,ÀT™Œ)ÅxõüFMw–p*ÚUôFÒô]7¦vå7@bÛ È,Oâƒádÿ8ƨ-÷¢û¶ãÍB@YÝÊM‹ßöÿWoÆÉekÚ4šÄ“H/Æd{Ö›S9¸í2z#Çú®›Ó{Äo˜îù 9‹mlõ)öÿµiÀ˜¿Œ Úã›ì'»y—ÑIÓwݘڕßÀÞòc̶H,̬ü0&Ž¢È{ä­Ü>ú1a4Ÿ^ž¿aVüö«·^W­þ;ý¦Ê4bL. T½¦SÑ®¢7r¬ïº 0½Gü†Yñ[l¿ž¢0U¦c’øí`éeÏ7û ?íèuÒ \÷&lW~C´ƒ“o§•–JÆdÀb» ï]d±ƒ%JRô[)¶d~˜pZüFs6¬–bDXmMâ‘cà¥ç˜„Ðî’ê“WÚÑ9Öwݘð=â7ÎŠß¶é Œ¬¶TÄb‚Ee1&ü2&º»`‰ðÓŽÞHš¾ë&ÀÔ®üÛ„àu¡Wºã~‚€úHÊ+tëИÂÑ^ Ù ü¨øÓmORFŒ,´Ð1kÓ ¯|2׫ç—7v¹É±«—I½‘c}×M€é=â7NŠß)û88#²`ÿ)†V¦Ñ©§ë®œíºÒ]ÒÐO;z#iú®›S»òŽ–ì¼R¼ýaLùP¾mkA«,#!Úú`ðôàÀËëë™È1AÎ@)S.Nå*Óˆ1ý²rÖÔî’j?Ù¥h—Ñ9ÖwݘÞ#~ãtå·‘+ûB0—uL•iÀ˜0p¾Sº™’b?ÙUÎ]Fo$Mßu`º©üvq™A½{µŽÉ6p".3ð¢Æä[8¤àý€õɶ'8=ð’}‰ŠXŽoªL#ÆdÜù—1݉ßxM±,£7r¬ïº 0½GüÆYñ’-î>¸sÙÁ²2 S¦‹1 ݉ßx*ÚUôFÒô]7¦›Êo Ñ~lo&)ËSR в‹ç¶«XRιr¶‰V¿ƒhÿzTcšxIöÊÛ¾VŽÉƒr¬2 “ËŒcÊoN~ñšbYFoäXßu`zøÓ/“DÄàÅB±¸+W™ú«k8i¶-ÛÞŒ¨4tM±,£×I3pݘ¨]ùM@¶ ‹ê-WJ‘>ÝÀ/¼eQ².Þ•K¬âs€ªÔ^^_Ï8ÇünŽ"p&#/Š×¦cIß¾ò9Þ-~ÚÑ9Öwݘè=â7M·=ѤÁS —ÝJS5ã$zu°½ÄÝÍoºz™”ÑIÓwݘڕß$$ÆõиÞG‚^aLG—8Ûµ(†¥IÇ]¹€äÃÁ}Vʧ“ÚMþw`š¿E7ÚFŸsÐRc*MÆDŸ“„ƒ1Ém :í*z#Çú®›Ó{Äoš­ü´MqR[ŠŠI¼•iÀ˜ŽÆ·c á.iÎrî*z#iú®›S»ò›íg–äð"@«•ßlÛ0û… Œ}ÞÉbw´76¿ŒHŠáI`šx ¶çDµÕÀËÒ4`LÈðö,ñ®ˆ—®)–eôFŽõ]7¦÷ˆß4ÝóÛØˆ·:f-ÄïÊ4`Lö"]ûºßDW#ï2z#iú®›S»òÛ8:Ë‹b ³ZÇd»1Nhÿµ|m+wôåu¦E)Úv–â?LÓ•ß™"J ¿Ú4`L úeL|+~ÓUÎ]FoäXßu`zøM“âwÒ¬‘SH¶²—÷˜*Ó€1Ñïþà.iòO;z#iú®›Ó]Ïo<&»ø¤Z­c²˜mÅg„µ¶'öq©_ƒÉ9zÿ̘Ÿ¦Yñ;¢Oi¶µ%I©cV¦c‚”¿§rÆ oN~éT´«èë»nLï¿iVüoefû.ô¡±ÅV®4 “o /Æd/ÔMÒð©hWÑ뤸îLÜ®üN¾›•c0À–¦¤@ÎÊ)ûu;\+gtÎl{HÛþⓌ‰gÅo?"„ce‰±¸’R™Œ ÓWcÂ;ñ›OE»ŠÞȱ¾ëÀÄï¿yVü6š£)eQð!d·r¥iÀ˜b¤ÿÚ †$7Is*ÚUôFÒô]7¦våwŠÆ˜b†²ÚÉu!W‹2ÆÕ~Lèy#&@¶×øI`š¯ü ,)‰Š–•iÀ˜ìϽtLöë79ö-ç.¢7r¬ïº 0½GüæYñÛ¶Õ ~­š ÆT™ú«™ws¿º €m¾nÚžð©hWÑIÓwݘڕßÉwb/ õ&«Œ)ç"G#>qE9?“HÊþŠÁ“â7ÏV~«‘̆–>H§ JÓ€1ÙVà[ùm¿Ý0åÜUôFŽõ]7¦÷ˆß<ÝöÄøjÈšs(NL*S5#±wâbL î„I¾z™”ÑIÓwݘڕßÙk¾»Wt}obc>ö‰®vð¾Bþ§²í{“>©1ñ¬øM ‡bFÆâж'•iĘà«ç3…xL§¢]EoäXßu`zøÍÓ=¿%³‘rÛrØNì/0U¦c2>sÕ1Ù Å7§r|5ò.£7’¦ïº 0µ+¿m §~‡×'¼­ÈDcʇüm¤ÉˆOZí`i[³%e}˜¦Ûž°77 !ù»øÕ¦~Že‰ßÙ…ùVǼz™”Ñ9ÖwݘÞ#~ótÏïÐ^}[|,•‹“Ò4`L¬tí|zÓ c’«‘w½NšëÀ$íÊï$jšl_VOåŒfÃyŠŽKK㛼»€1KÉ’"ÙžîI`’éÊo¶Fû]âweêçXF€‹’¦»¡ªr•s—Ñ9Öwݘä=â·ÌŠß|(rPV(G„W¦còRã‹1yqáMÒÀO;z#iú®›S»ò;ƒø<<#N>­{•1áÍÈFšÂ¢ÆäV4Û‹f3ð“•ß2+~{%ï]è]ÞŠ­\e0¦o¹€-„zöÿn䨩hWÑ9ÖwݘÞ#~ˬø–Ã8)‹Œ©2 Sä¯Ö †R7M¼äT´«è¤é»nLíÊïl„'‰„(ê7—5¦Röv qu®FÖ˜¼AFz˜¦^ÚoáÒ¢JQ`Y™Œ ¾“xî书X–Ñ9ÖwݘÞ#~ˬøÍbk„O¹)TSaê¯f¨¯ý¿ŸYß1&ùiGo$Mßu`jW~gaÛÂQJFW|k Y$Û-ΕCÛ>ºj® ¢ßé·ÿ`š¿U™bÌöËÄâoe0¦èªü¦ pÓI.E»ŒÞȱ¾ë&Àôñ[&ÅoµE9'%Û+qQ•[›ú«*~» Ø.Bï’æ£h×ÑIÓwݘڕß9úàà½Ç]^íù •\ÚµßÜþ½x*—¬e ˜í{˜¦ÛžØg!#ç¢V®2 ¦={-ýŘ8ÜÓÕˤŒÞȱ¾ë&Àôñ[fÅoW°WÍ[¹Ò4`L9kL’Þœ˜¤SÑ®¢×I3pݘR»ò[m+^Ë^ǽȘüTÀöÆ.b¯V~«QKo“!G|˜Ò¬øí·¯ '¹¦ÚÔÏ1ßÏ_:&1ÀM­\:í*z#Çú®{Szø¦Åo__í[Öòoe0¦„zíÿý¬ü˜.E»ŒÞHš¾ë&ÀÔ®üÖLG/&ò†å«ŒÉÛ¼°úT9\ßtÝ'õž}9¤GiZüû,ü^€ýLEÛ“Ê4bL.“(óø.E»ŒÞȱ¾ë&Àôñ;M‹ß¶J„¨˜²ÍSi0&Ƥc2d¼Ñ˜Ò¥h—ÑIÓwݘš•ßDDÑY¤³Ç5ÆÞY7 †¤iq®œ+æ!Š@ƒ¨'Åï4+~3{å’_T*€©2 “a=\Œ‰„nîÊ¥SÑ®¢7r¬ïº 0½GüN³âwö!C®ü–ÀT™ŒÉ¿Ô‹1ùÖ›¤9í*z#iú®›S³òŠ O´ûTOåìa£#Þæ™VöŸ:&¿T ÅíÓ¬ø4‰ñô± 0U¦c úeåd«Õ]ŽŠv½‘c}×M€é=âwš®üTöÝ*\t°¬L#Æå[ùíªíMÒ\åÜeôFÒô]7¦vå·ª·*ω8âÊ0ÝÆä'áÁçV äÕ))>!F¡@>àI`š­ü&5î‡ñ˜dUÌ•«L£Ù…)\Ýl 7â’þ´£7r¬ïº 0½GüNÓ•ß™ü»RŽ©¬ü.M#Æ”ÞoÊW9w½NšëÀ”›•ß(ø¥„®-jLöé‘ß<ô3"]±ò©crXJ"^¥)O¶=ɳâ7Ûφ FC5"¼0 &ñ0òŘ0k¸9•˧¢]EoäXßu`Êï¿óôÀKñ÷^ÀöØe¯Ê4`Lö^§r.ßÞìÿó5ŲŒÞHš¾ë&ÀÔ¬üö¡rÞÉÌ;#œEð+'±MÜÑ´{¥ýå‡1%û!Z¶?ŸøI`š¿ ]zëvãå%ÞÒ4`L†ØßI<)ÝiLÚÑ9ÖwݘÞ#~çYñ[¢7Â!SQ`Y™Œ ‘®QInªró©hWÑIÓwݘš•ßà½m—7&åÅ))öp´uÛØx÷ÎÕS¹œPÈ¥aÛN>Ùö$O‹ß>I9"f/Ð*Si0¦¾•ß(gU|#Ç.E»ŒÞȱ¾ë&Àôñ;O¼D²Õ]“ Ã*Óˆ1E¤/c»“|M±,£7’¦ïº 05+¿ôä$àEþ›,3&H^ómÃkmOœ1¡ W~ ÙæúIñ;OW~cûi n½ç_ÆTš]R•·¯¶'OåtVüÛõecpÙßú˜JÓ€1|+¿â\ §¢]EoäXßu`Ò÷ˆß:=ð !‘ßö({~W¦‘Æ$!~“CH;i®)–eôFÒô]7¦›Ê綠E€¡ª.ìÆÎ£dC–ÄÑW/2&°Å?FLâóžÜÊétåwŠB¶;Í9—“x+Ó€1EÐï$ž@·‹ßUÎ]FoäXßu`zø­Ó•ß>‰:yÿW?ÿù«1•¦c Ä_Æx³•Ó«œ»ŒÞHš¾ë&ÀtSùÀ›ãF°~¥ åYù-‚w § Gzc" †gjØä=Ÿ¦iñ›Èöµ^"Ë+)•i4‰ç·KªÓM¹€^Šv½‘c}×M€é=â·N·= ¶Pd[ˆT¥l{Rš†“„_‰oŠßôêeRFo$Mßu`º©üVoSîÍ·}ºëªÆdØb袮2­´&8“QcÌ@l›’'{~ë¬ø-ÞÀ˜\‚\6Š«Lƒž_šäÛÁB)߈ßz*ÚUôFŽõ]7¦÷ˆß:+~K¢cVlöKBÅV®4 “ß:½“í¹î’æT´«è¤é»nLÍÊoˆÑ÷pÊ™5àR¥?ì㛲mbíS]dLƶ²—”Ù[Æòäø&xiߟmjýЋ V^™]RsŒ¿“x讵Ž^S,Ëèë»nLï¿uRüNÙϤûœÄ¿«Ye0¦ø¹í}¶:‹í¤‰!ü´£WI3rݘbýÕÅOßô>ÒÞ]V» øp”LÎ:ƒd]Fðé>cÏÆìÃxùÁËóëçX6òg/|”à—øþSeÍ.üm˜`«ÔÍVÎØæO;z#Çú®[S ¯¿ÏÏ{"iÐÛÙ ’ßnû«1•¦þjví\Œ)ù¡k;i®rî2z#iú®›S»òÛ…g Á¨‹f]í.€h¿²ÏéspZìÇdÀ¼âËžÎ<•;¿žqŽù,I²m~Ÿtówñ«L)ûÊë§Ø²•c×Ë2z#Çú®›ÓkÄïóó'M¶ýB"ÈÁòË~L¥©¿šëcû?n’æT´«è¤é»nLíÊodÅdk0G^¦ûiLÌQmFªV.ÚŒ)9S¿_‹~nþ/À4+~ d®€©ØÊÕ¦‘Æ$øË˜Ú•ß1œŠv½‘c}×M€é5â÷ùy“Æ©ˆ¨¿F¶º‡‚1•¦cÊ$W¯ÛDÜŒá*ç.£7’¦ïº 0µ+¿QHrŠ˜Ù€i±ƒ%øx”’D9­5Šs){kGƒpazò®ÜùõŒs̯îùGqt)†T¦‘Æ”â—1å”Ûå1œŠv½‘c}×M€é5â÷ùy“&CBˆÑñâwe0¦ô{gÔöêØ®cŠáT´«è¤é»nLíÊoÛÉivMÕVàµKgLêSá„?wKVOå8I ö[Ä– œ_Ï8ÇRL!0RÎEŽÕ¦c²Eê;‰'ó­Æt–sWÑ9Öwݘ^#~ŸŸ÷8i|˜$Ùr!YþVåÖ¦c’Nå˜àf+§Xþ^'ÍÀu`ŠíÊoÛt‰QYfLöv&x’×ÚžŽÅþL%—rõÁÖºç×3‘c~£Ù~&×ò¡¸Y™FŒ‰3|“¤`Ч¢]EoäXßu`Šï¿ã¤ør`›b,§¤–¦c¢O«“ƒ1ÑÝø¦á§½‘4}×M€©Yùmû0£w’d8{æ-0&¿é bVOåÔÉ++À>ÂgiRüζûË»ýs9%¥4NåÓWcÊw'¿ÚÑ9ÖwݘÞ#~ÇYñ›ÄöÖBâ6Š£ÜÊ4`Lò·Æ›))1žŠv½‘4}×M€©]ù¢½D¶óÎJkâüá`[a¶‡™ÖçÊiäl»’àµßéÁI¼ç×3α$ÁÛ"G朥,°,M£S¹ßÛ |Óö$ÆKÑ.£7r¬ïº 0½Gü޳âw‚“fˆ@T¿U¦c‚øÛ]r¸ÛÊŠv½‘4}×M€©]ù-ll'd±L—™èØlßjlÉïøÐrK¯]6²EÈÙÐíI`š¿í}~oQqW®2 4¦äÝ’.ési¼•cé§½‘c}×M€é=âwœx‰ÉK”á½ËjÓˆ1ýÞc2fÛ#Âc¼¦X–ÑIÓwݘڕßl?-ؾsbX½+çÓ¯Y©íéÒjKRôû^ìåòðèVnºçwöæ~Rs9‰·4 4&TùÎ.ä³@¬‘cW#ï2z#Çú®›Ó{Äï8)~k´=é÷É0U¦cJ|½¶•»™+á£h×Ñ뤸îLЮüF£-ä…D~l¿Ø]0‰±Cq‘ŠÃÒ%^¿¤‚Œ~¾2>y*³mOb–`K•-.ŠS¹Ê4`L!kå€Þœ½Lªèë»îLðñf+¿ÙˆŽ½ö!¤Äe£¸Ò4`LÆi¾Ý0ßÌ•‹p–sWÑIÓwݘn*¿Á`Y-Í­jLè`2é²-Ùj?&CÄl[é˜øÁÖºç×3αDÇ„[— QŠI¼•i4íYÎnÁÇB(7â7\¼Ëèë»nLï¿aVüæ g[{ˆÊ£ÜÊ4:•û´èø0¦|w*§¢]Eo$Mßu`º©ü.G/è¼ʘ@5x#'$ƒ§%ñÛÛ¹.Å>ÍÂ<©1Á¬ø­è·½ažäâä·2¦=‡¦=çØ¾(áT´«èë»nLï¿aºò;³øž2«Ym1&Vù2&‰w4û*ç.£7’¦ïº 0ÝU~ûà`Å}C¶\ùm;±h¿1]Ÿ+G1g!Æl¤íQÆ4]ùmëJòÒE-G„Õ¦cÍßiÏFsîä‚«œ»ŒÞȱ¾ë&Àôñf+¿£ -CöØö¡`L•iÀ˜¾'&>nâ˜Îrî*z#iú®›ÓMå·q&ïxâ^W&0¯œ’Ov°=ìÿÇ©\°Ï)Á4ΕðIñ¦Ûžxŧ¤cªxÙö¤4 “Ñ™ïìB{ö¦$®^&eôFŽõ]7¦÷ˆß0]ùÑÏЀ¸¨cªLÆ•®)©¶šòÍ©^åÜeô:i®{¶+¿™ØÏF9@å…Ç+ÇÈ)+3€_@\Õ˜lUˆ‘™À êIÆ„³â7¥¨’3ß,*4¦Ò4`L‰Ó·„›aOE»ŠÞȱ¾ëÀ„ï¿qVü&9ú·ÚRä¯@Q`Y˜Œ)’~5&À›î‚á§½‘4}×M€©]ùmÀ$½Éu¢EÆÄ(r[¼-Ï•漢öpÖ{~Ÿ_ÏDŽY6Rû¡ŽŽÝ¿Ò4bLðÛÉûºÜäØYÎ]EoäXßu`zøÓmO¢2Œh¬^V¦c Bß:¦˜ï*¿ñêeRFo$Mßu`jW~û1Þ0E\Ä+ý\ÜW2î´ª1Ãð• >¹•ÃYñ;S_|7®Åí‚Ú4Ò˜òwÚ3DÎ7§rÈ?íèë»nLï¿q¾íIR•äwº¨lWšú«YÔ:XF‚ ¿½LŠè¤é»nLíÊdÍbùžâjË$‘íT¶w…—Úž¸Æ¤Þ×v$þŠ=y*‡Ó=¿%äHÓ^ ÿ˜*Óˆ1Qü=•Cº“ ®FÞeôFŽõ]7¦÷ˆß8-~+ h_ K±•«LýÕ,*ÆoK×Wn’æR´Ëè¤é»nLíÊïL¤)¨7à«§r&D‘“.oò™h{ƒDEò¨Æ4[ùm¤Ñ»FoéYœÊU¦c á«1yœ›;˹«èë»nLï¿qVü–Dl9,öö3¿jÓ€1ÙÞáüê7o4& ?íèuÒ \÷&jW~ç¬Â¶ó@•%ñÛ“‘žÌÞ­2&Cïà7¾ É‘ž¼ÄK³â7«HVÁá/0U¦c¢×|…¨šoÄo:í*z#Çú®{½Gü¦YñÛÖ×l­È\öÊ)MÆ”õ»šù`ûÆD§¢]Eo$Mßu`jW~g[%Ù†Ì8ÏJÛîcò}§4¥•ž)Ÿ»r½³Oi÷²¯iºç·aXì}†Cq*W™F³ 9}»¤êGÓlåØÕÈ»ŒÞȱ¾ë&Àôñ›fÅoã°$ š]›FŒ ò÷T.œmIs*ÚUôFÒô]7¦våwN„>Ý- †åžßYÐ…5¿¼$~Û»Kö'Šñ4ÛYÿ“Þ>ü_€iºòE½HVR!~W¦ÑìB¤o_ù¬wí›é*ç.£7r¬ïº 0½Gü¦YñÛ»%êq š]›Œ)©~û1ùûx“4§¢]Eo$Mßu`jW~ûĆ ™—ÖÎhÞÒÃhÔÕS9·\–sDdy˜fÅoŸC…d{$ò›n©4fbúꘖ7מèT´«èë»nLï¿iZü¶µÝf1b^6Š«LÆ” ^ûÍŸ ²ÐHšKÑ.£7’¦ïº 05+¿Ñ¸_ó3Ú³Ö(Î9c2Dæ´Zù!ùõ]õë_úäø&š¿YÄ;æåè…ø]™FŒ‰åÛóëš$ÚȱSÑ®¢7r¬ïº 0½Gü¦iñÛ[÷½F!CqW®2 “H¼öÿÊpôj_Šv½NšëÀÄÍÊoÛÆ±!uˆ‚+Ýqáx8{××<ìMYÕ˜¼V0û$dô:¨‰gÅoñ™¹`ß#çrJJe0¦ßsíñ†•ó©hWÑ9Öwݘø=â7O‹ßêƒ$ƒFI©FP™ŒIè{5ËgÁÒ 0]Šv½‘4}×M€©YùíÍGB 1þ’Oå0bÀ”|È™¢¬Î•ó2ÔL Ž¢œ'çÊñ¼øDíaŸõ^Šß…iÀ˜‚ç‹1%¥“¿Šv½‘c}×M€é=â7ÏŠßÆF"j¶ù*¦¤Ö¦c²µæË˜bø”4’†~ÚÑIÓwݘš•ßèg"J°ÝgÒÅS9ÛÊa/ÌA×^“x5mõ˜Â£WRxVü&"²wˆU?¦Â4šöœÂ—1¥[“ù§½‘c}×M€é=â7OŠß¶.“°øaG,{åT¦cb¥kVoayLòÓŽÞHš¾ë&ÀÔ¬üF§ä-v?÷N—Ó1|)ä¤9¯3&Kž’íI“â7O·=ñáÛÆo–9VšFÓž?Íá>ŒéA×6ú‚TžÊ•¦Ñ´g8‡øBxŽOo䨩hWÑ9ÖwݘÞ#~ˤømk2ÚN‰Œì¤²íie0&ûR¯?{½&úiGo$Mßu`jV~#ˆ—0e¶½Âbå÷ÑÀÏ51IÈ«z×Kô©—ã“WRdVüf2ú˜‚÷O*Oå*Ó€1Ég8ÃÁ˜øÓ›©L§¢]EoäXßu`zø-ӕ߈j¯€xIm¡1U¦‘Æ¿ŒÉö’zLW9w½‘4}×M€©YùÞX²ß õ»)‹Œ ƒp Î|l_Õ˜€4)Š}fÏ2¦Yñ›1ÛÆË‡$•–¥iÀ˜8Ñ5%%ÚïyL§¢]EoäXßu`zø-Óâw:Cä¤eÒÔ¦cBM×mò™1ßHšKÑ.£7’¦ïº 0µ+¿!ù—àê˜.Mù>SFJöâûYßäÕ™ ɶsm†åOŠß2=ð2°ïY0¦Ê4šÄÿ]R îÚžÈ5ŲŒÞȱ¾ë&Àôñ[fÅo¿ö h_Šf,ú1U¦cŠñê`™‡›­\:í*z4×=€)µ+¿á¸vŽSž•î¸cŸå ÞK˜#.Þ•ƒœýäW,>Y.fÅoõÙÛ’%€ÆPÈ¥i4‰'‡/còâÕ60¥øÓŽÞȱ¾ëÀ”Þ#~§Yñ[\ÄT9z-––¥iĘäÛþÇ60é¦À2Šv½‘4}×M€©]ù Þ@|RÉJK¥cÃuû…Á¶²4¾ÉOÔºR‰ög?Ú)Íöü̲f–T #¨M£I æøä©\žîùÞéÀ«M)Ã*Óˆ1á·Å”o n4¦|5ò.£7r¬ïº 0½GüÎӕ߉m¶×'HÕó»4èUc"ú¹ùݦ«œ»ŒÞHš¾ë&ÀtWùíÝ%p©AÀYùHmæOaq®DâmkâmyñIñ;O·=g#ö«®ü=`©M#ÆD1}S7åùêeRFoäXßu`zø§{~ °Bö¿ËI¼•iÀ˜l¥¾ÞÛwÉ0]¼Ëè¤é»nLíÊo”ä•ßÞ 6¯]Iñ‡ Zƒø¤³åü`LÁo;ûÄZöŽOÓ¬ø-Yì§"ÀÊá•iȘ0þ2¦»S¹¬?íèë»nLï¿ótÛ£!^qÃRÌ•«LÆY®a¹k{¢W/“2z4×=€IÛ•ßÈ~Ã/ysÝ$Ëwå“Oùô{Ñ+Ó2Ƽ©°áZ€ø¤Æ¤³â7¡‘8  3‹rÊ4šö|.xc¢t3TUãO;z#Çú®{“¾GüÖYñÅ–vð ¶-Ð…ÆTšFŒ‰éZÍ„ nÊôT´«è¤é»nLíÊoŒ$ö—ýÈ~½ª1ÙN8ƒÑ&À°‚jž4ö¡mâìO%{Íž<•Óé¶'^Òe;ZFÒâT®2 rLá[Ìîcèoú1éÕˤŒÞȱ¾ë&Àôñ[gÅïèßdpŠ­\i1&„¯ÆDoÊôT´«è¤é»nLíÊoƒÑìã€@ÏvmKŒ‰Œ}b>Áâ©\´=‰ù©)=Yù­³â·‘F5¨Eòè©2SüæXôá…7Àt*ÚUôFŽõ]7¦÷ˆß:+~ËÑ‘Ì˓ʻr¥iĘ"^ ´`à;`:í*z#iú®›ÓMÏo¯ùŽNzuµƒ%øDñ \Ê ÷YÆ$ö’Q2pò¦ãOŠß:)~8ˆO÷9$ÅKiN{>)ÓžoÄoM?íèë»nLï¿uVü[Ù…E;¬üMšÒ4XÍ\u½SøTå¶€éT´«è¤é»nLíÊoTäªz‹»UÆ”0 &µw?­vˆý‚¼PJ~œù$0MW~Û‚BY˜°Ð˜*Ó Ç\¢¾SH·Œé*ç.£7r¬ïº 0½GüÖYñ;Öµ+ÆT™«Y oKV€vw§¢]E¯’fäº0AýÕSð&q ’–“‚ÑÏ óJûKüVEQÛE¢<ÙóûüzÆ9–²ˆeV¿½_ôü®L£iÏé·Ž)µOå œŠv½‘c}×-€ ÂkÄïóó'Mv×lÿðyÒ5¦Ò4bL¨Wwöû§7Àt*ÚUôFÒô]7¦vå7ÙÏOЬߕCûU9s²] ð"c²Ož¢OöËrTgÞ¤Ò¦Ù¶'Å;ÞAZñ¦AŽ“‰?Œ ´}*ÚÑ9Öwݘ^#~ŸŸ÷LÒx¹Mâà׳ÊK¼¥©¿šÙ¶ã˜æ?9“äöø&Ûàü´£7’¦ïº 0µ+¿9F[àq½ò›Ôf\ª58>ú¬Á뽌2ECÇ'iºíI¤ä,ÆpRQ`Y™FSdú2&¢¶ÆáêeRFoäXßu`zø}~Þã¤ÉöIù -€©4õW3ï—”÷À“/ú7À$?íè¤é»nLíÊo²í'DŸÔ?u§+Œ‰ ãSpÆå“¾WïÊÙö/Ú–Ä¥ïãðcÀ4[ùí8iëÃÒ‹"ÞÚ4bL‰ø—1…ö]9ûÿÿ´£7r¬ïº 0½Fü>?ïqÒdv‘9Ø:µh­[™Œ 5å‹1a v%„«œ»ŒÞHš¾ë&ÀÔ®üö""VC¥ÏAÒc±Ü`…âbå·_Yô¶'Æ—$žc¦éÊo߀yðP¯L# øª€P¹}QÂUÎ]FoäXßu`zø}~Þã¤É(À˜Å«fr!~W¦c ŸÑ:c ÚâìEûiG¯“fàº0Åvå7BÛ…¢ÄR£8€yO&€Uñ›l»ëäUÔ{ŽóƒÀ§+¿#Cò9$\\I©LÆ$/ƤÇ2Õα«œ»ŒÞȱ¾ëÀß#~ÇYñ›9 ùi©½öcªLýÕì§/Æb¸¿ã©hWÑIÓwݘn*¿…sâäôê\9ƒ56’h»AŒ+Íœñ;$dÒä›< LÓmOìdÿ§íÅ ÆT™ŒI ^þÙÜÈñêeRFoäXßu`zøgÅoŽì̲úж˜JS5Ë)ä‹1‘¹[ÍNE»ŠÞHš¾ë&ÀtSùM’Y¼ ),ÈDŸS9ÛŽE„ì÷ÝqqàeôY„ªéér8+~u„à×c«I<µi4í9ïcj ©}í â©hWÑ9ÖwݘÞ#~Çé¶'Š"–ÅЛߵiÀ˜ì«ÅsöA¼7§rñêeRFo$Mßu`º©ü– Â²1¦µr£ò[s&¯ÝòF–‹)ù4^p²FXž_Ï8ÇŽjÑHöÊ3bQÇT™Œ‰!_÷1-ßäN.8í*z#Çú®›Ó{Äï8Ýó[|–Ûw”Sa0&×/ÆdïÕ0¯FÞeôFÒô]7¦våwLY1?óÿ4ZXê`i› oNàãôté®ÜQm;^Þ`ïY OÓ¬øm¹`§ìÝÂ_`ªL£Ù…‰¯:&û?Å–;í*z#Çú®›Ó{Äï8-~g{‡lÆä›¯¿ÀTšŒ‰¢^Z«ºYÍàR´ËèuÒ \÷&hW~{&ŸësZÕ˜l7–C²M™m-òÒ\¹cˆ¿[¶“ ÆšžÜÊÁ´øü7QÿþrQ.P™Œ‰$\§r¶^ÝÕÊÁ¥h—Ñ9Öwݘà=â7LW~3Û0úQNqÁ²2 ~î.Œ)…›»rW9w½‘4}×M€©]ùüãHçp¹U)Hd{O>ŸãJ£8¶ /½b~5éÁÖºç×3α£Ê +xo€¿âwi1&ûõ.ÆdØ£1Á¥h—Ñ9ÖwݘÞ#~ÃôÀËàƒÈ/WAq] 2 SHǶã`LŒzsb×Ë2z#iú®›S»ò;€%9k:zä.“‘Uïgûa<;6. ¼‰¼ŽŠì5~˜¦+¿ ¤í§ ¥,¨L#ƾ¿RpÓ¾à*ç.£7r¬ïº 0½Gü†iñ;“0ûùr,ï1U¦þj–Ô6/c"â;š})ÚeôFÒô]7¦få·wÑÐ`o‘m«xuJ ¨ÏÌ «mOÐe2'õ‰vDOÓ´ø-Æâ޹å)ÀT™F³ ógúŽOâÑx§cÂ¥h—Ñ9ÖwݘÞ#~ìøíM!#²Ú’Z›ú«Y2fsU~…pL§¢]Eo$Mßu`jV~#”Ô8“¯Ã+3+Æ”¼ÌBJ /ñ¢¹Š  ™#É“À4+~Û"¥öÚfÉç3ÿÕ˜JÓhÚó§ˆ÷˜Äã—œorìT´«èë»nLï¿a^ü6@{üîg)~¦cÊô«1¡ê 0áWÑ.¢×I3pݘ°YùmìQ ã ¶ŒÉöbèýÞ0FNK–^6îMú $|òTgÅoaûe$0y«…b+WšF“x2^,Þ–¤à©hWÑ9Öwݘð=â7Ί߶DŠö·jY.P™Œ)Åo¡1!ÜÊá©hWÑIÓwݘš•ßÀS&[ŠyåîÁ˜Èv‚!ÇL1,jLxŒ¤ ¨†âøè©Ίß9C^@ŠS¹Ê4š]Hßù ¶åºëù…§¢]EoäXßu`zøÓâ7 YS4*[XV¦c’ ñbLÞ²ã&i.E»ŒÞHš¾ë&ÀÔ¬üò9¼™À¾‰ «“WGë! 9ÇÅ—¨lÛH5tJJøà””óë™È1Û†§Ä˜5çb®\mÏ.¼îÊ¥óÍÉ/òO;z#Çú®›Ó{Äoœ¿É‹øX-‡¡œ’R™Œ cþžÊ½«1ÁSÑ®¢7’¦ïº 05+¿y·Tc>a±Ž ЯºÛV0&«ã›ìÃbLjqò«…ÓlÏïàÚ2fÊžß•iĘò—1Ñ] <yWÑ9ÖwݘÞ#~ã|Ïo{…2“ «Ye0¦À™OÆdËöÍ\9Ào#ï"z#iú®›S³ò¼"z‡ê(°v‰×o d/ž÷VZ¬ü&Ž mkONI9¿žqŽ%£oŠ`«‹jqQ¼6Aþ2¦,7â7žŠv½‘c}×M€é=â7Ίß}êk AŠ–•©¿š‰}µWÃDL¢7ÀDá§½NšëÀDÍÊoÛrw5ƒÄ º4¾Éñ•œ—¶rÆ˜Ž’ï˜m÷ çœö‡€‰¦ÅoÛˆ#pÌÊá•i¨1}]cºË±KÑ.£7r¬ïº0Ñ{Äoš¿~•˜«S¹ÊÔ_ÍÄ(\ŒI8Ý´=¡SÑ®¢7’¦ïº 05+¿ S˜"D" ‹ý˜l'–ƒ×@ô!Œ«ŒÉ—2{›8ŒŽ?¿žqŽùñb2>m_Ÿ×/ü­c*M£Ù….ÉB¾aLt*ÚUôFŽõ]7¦÷ˆß4)~·ÑÚJ[ž˜”¦còÙ_ÆtRîFÒÐO;z#iú®›S³ò;ª!Êq6\ïYcLÑoïéÑhŸ.v öRB®}?¹•£ÙÊo/Ds—Ôþ]äXiÍ.L|1&Ë7¸9`¡³œ»ŠÞȱ¾ë&Àôñ›¦{~cPïAc›¤T#(MÆù[ùí¯Åcºy—ÑIÓwݘš•ß>Èû œ‚Ðâ$Þ赃ýlN0.‰ßƘÄÇ ¤¤Î¶Ò“â7ÍV~Ûn6'ïÏT6Š«L#Æ$ru°í.Ý” ÐYÎ]EoäXßu`zøM³â7‘¥ptL±º8•+MÆ%~áÝQ.åŸvôFÒô]7¦fåwdòþ•^ͤ´RŠŸ™•â5[mð™Ï·Â˜Èv¾ ÉØÅ£À4Ýó›}œýN¶°„Bc*M#Æ߃F¡Ûrºy—Ñ9ÖwݘÞ#~Ó|å·íR@,‡T¦c ¾ŒéjžX' ˹‹èuÒ \÷&nV~ÛLP|jº*/ ¼ô³§d/¡}òÙ¯0&‚c>¹ý±)êƒ#Âϯgœc^àR"ËzAi1¦@×]9K‰»Fq|)ÚeôFŽõ]÷&~øÍ³â7ú¡úÕÅTSiê¯f¬¾Ñ:hº91áSÑ®¢7’¦ïº 05+¿cä51–ê¨+ >ƒ‰0yaµ±%Û½.V~;We/8OIž,°äé¶'˜£%ØÞ²˜]X›FÓžsü2¦øØ×ʱ«—I½‘c}×M€é=â7ÏV~‹¢-¶ë8:ÿü½’Ršú«'Œz1¦¨w,ù,箢7’¦ïº 05+¿½UKBÔc^‰ »"ýMšƒý¢€œ5«Œ ²B{ÍD?Ù]€gÅïȶŸ=æ#h,îÊU¦Ñ´gâï´gE¾[üNE»ŠÞȱ¾ë&Àôñ›gÅo ýBº±’˜JÓ€1e‘¯Ær×ö„OE»ŠÞHš¾ë&ÀÔ¬üf¥ÉÇ| ÃCû¿Œ‰½¨&e•’Ç2QÁ˜¢~ûT™0> L³âwfµ]’y̱:•+LƒÙ…ùS­zLâá$w9–~ÚÑ9ÖwݘÞ#~ótÛ“¼Ù¢-ïeKŠÚ4bL‰¯žßîöÿW/“2z#iú®›S»ç·úFÇ»jú\!\`L(A½ÀòíºõaLìuãÉ@Â'ë˜xZü¦Ì¶gÌPȵi0»PðÛWžIî*¿ùR´Ëèë»nLï¿yVüb-Ì€~íö/c*MÆ”è÷T.j¼©c’SÑ®¢×I3pݘ¤Yù QȯªÛ.ôêŸ?¯1}.-û¤o ãâíò®œmål÷hüRåÑÊo™¿“a¤—f%o›WhL¥i4í9ÄKÇ4ü7‹ŸœŠv½‘c}×=€IÞ#~ˬømüÕ)+Û»_´=©L#ÆèWc2¦p“4§¢]Eo$Mßu`j·=¡ Ní_§ZM%A¼û%ïµoPÿ½=™4Ê,HÞq…“[9™¿5Eñ¶µ`ûÛâJJeô•WMábLAï“àO;z#Çú®›Ó{Äo™¿ÁG3Fß+A.[ë–¦c26œ¾Œ ïŽråT´«è¤é»nLMñ;jfÅ£-‚ü^ÛÊÆ`°’Ùö‚aÜ·¬cbà(IõSõ0ÍŠßν-€ý>eåwe0¦ð™’r0&Ãü›"^9í*z#Çú®›Ó{Äo™n{}ž8ŠÑØRü®LÆd<˜.ƲÞmå®^&eôFÒô]7¦›—)z_Üh¬Eixhÿ—1y‹—dÐÌ9ê°×[YÇ$ÞíÓïÉåðh“̊߀‰îf(Ë*ÓhÚ³Òï´çÄ7år*ÚUôFŽõ]7¦÷ˆß2)~'É>ãV²Om/V³Ê4bL òeLp×]PòO;z#iú®›SSü&Á˜Åç”%£/ 2‘»Ù+‡…0bX¿½»€wæ5@d»º'Ç7ÉôÀˤ~¨ê÷šËá•i4í9Åo—Te½ÛÊ]S,Ëèë»nLï¿eVüÎQÐ †T0¦Ê4`L p1&Иn’&Šv½NšëÀ”šâ7g¿sÔ;•ëÚ©œ×4Go9dŸÂ°È˜3Û®Ds€'OåÒôÀKc€¼y9ð²4 “÷¿¹SéF.H×Ë2z#Çú®{Szø&Å7a'¿Ç«~Ì…iÀ˜PòµšO-ºIøiGo$Mßu`j¶=9†»e#{ \†^,°  ÙlWá=SVS"ÉUb:g?LÓ•ß½¸ÀïÈÆ¿E¼µi4íYã¥cú]Ÿ»Åï*ç.£7r¬ïº 0½GüN³â7¢ú=öàÕBÅ©\e0&ÿf/Æ”1Þ\°LôÓŽÞHš¾ë&ÀÔl{¢ ¤Âl¬Ç'–¬1&9¦Ã‘¢×2-2¦ RðŽŒ~7åI`š¿}l§·¼3”.€©2¦=+üN{Æ»S¹t)ÚeôFŽõ]7¦÷ˆßiVü^ˇês‚BqW®2 “wοSŽ|sb’NE»ŠÞHš¾ë&ÀÔn{mŸaIžH”WÅÅH,¶ cI´ððg‡c‹¾×eŽÃ£­uÓtÛ“à?MLÞN»¨cªLÆ™¯Ú ’³~´‘cW/“2z#Çú®›Ó{Äï4[ù-–úA|>¥hÑ(¾2õW3òf²c2J|·šåÜUôFÒô]7¦vÛûÿ0ØÁ²}­“u46€!±í.“¿¯Þ4%Æ£·> L³â7‹_e²-9uL•i4í¥xs*—NE»ŠÞȱ¾ë&Àôñ;M·=A¿»Òq½ÚÊý5õW3ÒP{0&{¯nº æðÓŽ^'ÍÀu`Êí¶'$AÄ6qÆzp­ƒ¥?¬Y½a9uZœÄK¬™0­ 1Ó“/ótå·}qÁ5ƒJYù]šF³ …õbL˜è†•竜»ŒÞȱ¾ëÀ”ß#~çé¶'5ˆ_à÷ƒé˜ Ó€1e{/Æ$™oÊòÕˤŒÞHš¾ë&ÀÔn{"–æÎ!–“¨ýöG?%^œÄK†h rÎ t­}˜fÅoñÂE`ŸøRõc*M£Ù…¾³ ñSžÒʱSÑ®¢7r¬ïº 0½GüÎÓâw4ådïQÙ©4 SÊ.Æd¯›£Ü|)ÚeôFÒô]7¦våwŽ)åßžò‹/c¶\ â½ñ>c°–:X~ú‚íM$>ʘfÅoI‘EÐÁIy‰·4 “÷¾ÈÝK>í*z#Çú®›Ó{Äï<ÝóÛ\-‹]].öÿµiÀ˜Œ%]wå€og~å«‘w½‘4}×M€©YùÕP!{w\1δLþ°&ÛÚ6ø¾l‘1¡·cLn^Æü(0M¼LäÓ?íC)¦=W¦c²ò—1Ùg|#~çkŠe½‘c}×M€é=âwžîùíT$Ó‚´è.P™Œ‰”¯î@énA¾y—ÑIÓwݘÚ/cŒâPöCÅ…A'Ç]9ïfßÀ® #8°Ñµ@âã垦Yñ}œ¤ ©m.ÿ2¦Ê4`LtµÖqÆâM­\>í*z#Çú®›Ó{Äï<]ù ^¹è·Irq] 6 )]½r ˜îF„ëUÎ]F¯“fàº0i³ò"eg±¿˜W¢aF%õ-ÙªÆd“=e€Œi>y*§³â·_VbRõ–šÕ©\aM{&ýÎ.T¾ë`¡ñ§½‘c}×=€Iß#~ë¬øÍ¶¾ÚvþTLI­MÆÄ’¯_³ï’æT´«è¤é»nLÍÊoßy¿’Ø0b•17sòá9®žÊ¡1Kô|‰?+ÅcÀ4)~gÇIã"¶·´åoŽU¦Á$žLtåfºk߬øÓŽÞȱ¾ë&Àôñ[§Ûž'¥‚¶³.ZRÔ¦c ü˘@nNLôêeRFo$Mßu`jV~ƒyƒÜ˜SÐ…ÝØÁ˜ˆ!¢@ðÛ‡iùT.é1"ôÙI¼:+~«mkì·2öøWcªMƒI<ÿôcB…»+)z*ÚUôFŽõ]7¦÷ˆß:+~3g°$&‰ŒÅjV™Œ 05&¼-°ÔSÑ®¢7’¦ïº 05+¿ÁX†è¶—#-2&¦ !{“¨i¹Ž‰³ÏX±7ø¬Î| ˜f+¿%xÇZŒ¶¶§r¥iĘ”×1ÉÝí=˹«èë»nLï¿uºò;q"öÎs(‡”¦c²õæ[ùpw‰W¯rî2z#iú®›S³òÛ°…Áûžàѵo‘1±Æ`¿r8Ú1­2&’¼½@òæO6ŠÓéžß¶·÷Ý¥ü `*MÆ$®û˜˜à®\@¯FÞeôFŽõ]7¦÷ˆß:+~Sô3 (^cü÷T®4ÓgûöaLp3ó CøiG¯’fäº0aýÕÅO!—O^KD«#ÂÁÞoÏ@þªÈR¹€kL’lÿgŒëè”þ0_Ï8ÇÒQÑÙHIyÀR›Œ‰á[ÇdÙmÆd‹ÁO;z#Çú®[“ýo¦óó'MG áìéü˜*Ó€1yµóŘ ë0Šv½‘4}×M€©Ýó;©òØOì-îV“èeÃ3Ìùs °TÇDèˆ#'ãV~Ÿ_Ï8ljOà̈rÙ©4 ƒ|5&û?Ú¬ÃYÎ]EoäXßu`zø}~Þã¤É¨ÈŸÓøœÊ»r¥iÀ˜B¦ow ¼[Í®rî2z#iú®›S³òÛ¶qâýº½ÂâˆpÐH¶¤ˆiµÀò¨;Ìj°)rζ=9¿žqŽ%%oxé?SL•iÀ˜é˘˜ntL üÓŽÞȱ¾ë&Àôñûü¼ÇI“™ ú RŽRLI­MÆ8~O帽ÿÇp)ÚeôFÒô]7¦få·aKð"$ßÇ-“?Ìšm?–„y•1ÙŽ÷¨Iµ}ÜgfûcÀ4=ð2ýLÆpR.;XV¦cŠ˜¯Êoc†±}QÜãO;z#Çú®›ÓkÄïóó'M{ëíK9.0”奩¿š¡j¸F %‚7Is*ÚUôFÒô]7¦öÀË€¶M–åÁ{Qc²˜†fAˆAqm+ç_ƒó¬¤œ8s~˜¦ÅïìGñÆšZ°Ô¦cŠŸác¢»“_ —¢]FoäXßu`zø}~Þã¤ñ·ì]²Ì å%ÞÒÔ_ÍPƒÀŘ"Ý4ñÂxõ2)£×I3pݘb³òÛÞZŸ›9yWà¥KŸÊgl)dHÞáš–.ñÚ×BtåÛ¶&GÃÏç€)N÷üÛ#y·®Ì\iL…iÀ˜ÂoÏ/§”7:f¼y—Ñ9Öwݘâ{Äï¸ÐöÄüƒ"•ªµna0¦üÏ]¹x×öÔè÷O;z#iú®›S³òÛVï—)SÌy¡é`L‘½"¥q¹ƒ%ڃƔ$ =yWîüz&rÌ^yä@ÈÑÀ¤`å¥iÐ%Õ>Ëï´ç³›e+Ç®rî2z#Çú®›Ó{Äï8+~'CI½ýýßÕ¬6 “‘áoS@¼Ñ˜â©hWÑIÓwݘš•ßS¶w×~îå:&¯@!Hþ‹ë*c[òí•5P4h|RüŽÓmO|Œ¤wÌ1—–¥iÐW>KþÖ1Aº+ˆW/“2z#Çú®›Ó{Äï8+~ƒbT´·ÀþQ0¦Ê4`Lö}SÀ|L§¢]Eo$Mßu`jV~{INÊ?ç+Œ T“1.ä£â`‘1$ãš1¤¬ü>¿žqŽÙ»n{p{éU ¼Ä[™Œ)©~OåÀ é&Ç.E»ŒÞȱ¾ë&Àôñ;μTï³ÈÙÖv[¡ÿ&Me0&‰ùÒ˜¼X­}WÎVòŸvôFÒô]7¦få7’÷]·ÝFò¶ß‹ÝлÄeáø­û1²0…? דÀ4Ýó;[>øð þßrÒ4bL×À˃1…;Æt5ò.£7r¬ïº 0½Gü޳â7dûFlyµRY.P™ŒéŸ™_QãM£x„SÑ®¢×I3pݘ Yùm¬%ùtJΛ{~{oc=9Ë=¿ ‘¼KŒw‹{˜`Vü¶ŸÇ,¢€±,¨L#Æ$ø=•ƒÛcèâO;z#Çú®{¼Gü†iñ;Q6"K‘c,;X–¦c¢ðÝÿÛ>ý®Ž .E»ŒÞHš¾ë&ÀÔ¬üö«$~øl©îS§“ØFЛÈdã\²XÇÌÙž·ÏŸ Ȧéžß äá²Å0‚Ê4`L"p±r?"¸¦«‘w½‘c}×M€é=â7ÌŠß$‰9jÈekÝÊ4`L¾}¹S†tǘNE»ŠÞHš¾ë&ÀÔ¬ü6l±Ï#ÀQ½BzÆä'D>£LYdL¶¥Û@:ÇTyRc‚é¶'`ä&ø`â¬ÅV®2 £|û1…w9võ2)£7r¬ïº 0½Gü†Iñ;)†ìç]Çò\$Mi0&àxÝcò“ý›£\ŸvôFÒô]7¦få7fßNF¯Ü*9SVŸF—¼ (†åüsÚ˜Äq#Fõ3¶ö1`š¿1ðRÛ¢¦¢Se1&’oSüŸ¶r,ý´£7r¬ïº 0½Gü†ÙÊoæ ÆùÅït5&•iÀ˜"ïÊÅd ç&iòO;z#iú®›S»òÛ0ÅÅ“ä´2èä`L™ÐÈNŒìí[¬c‚hïgõcLÖ'ë˜`ºòŽ{û9И*Ó€1¡Â·Kªê]­\åÜeôFŽõ]7¦÷ˆß0Ýö„rð·€ù‡b+WšŒÉ›­~SЛÊo¼z™”Ñ뤸îLØ®üö±1æŒÇ0ÞUÆ”Šß°ß7,• ø¹Ã9Å…'^ž_Ï8Ç’!ñ A•ÀTšŒ ø«cZ¶…»»í2z#Çú®{¾GüÆYñûÔWW˜‹S¹Ò4`L†EWS4žpSc‚§¢]Eo$Mßu`jW~g²õ—ü~H]ì`‰j Q³wURJ‹ÝŒ`[Þè%çðdÛœ¿2’ämi)çÊU¦cŠé·ƒ…—bÜ䨩hWÑ9ÖwݘÞ#~ã|Ûõ]ý:Zq*WšŒ)„ï‹(w⿽LŠè¤é»nLíÊï|ÌvÃè„x±ç·w³&Û[°X¬c²]tÈ>/4˳ŒiVüNGÏöapQ+W™ŒÉxà—1eû|orìT´«èë»nLï¿qºíIŽêu/Ñ^þb+W™ú«™­îÇÝ¥c r£1áÕˤŒÞHš¾ë&ÀÔ®üÎÑ»ë¦ ¤¸v%ÅNÉÛ¼Ø6.é0ÙšÀ¨Þ‰•#V¦éÊoÈØ›D[¹Ê4èù¥$ßiÏé~ñ»Ê¹Ëèë»nLï¿qºçwV¿ÊÎÞ¥û0U¦þjæþ=•ã$75&x5ò.£7’¦ïº 0µ+¿‹_¼"£M"«Œ)ð1¦ÏiÕŽ5Á%¿cÇ^4ðhk]œ¿½¹²l»¤ %c*Mƒž_ù3_á`Lr{Wõ§½‘c}×M€é=â7Ίßm$˜"S9W®2 SÎt­fLñ˜èT´«èuÒ \÷&jW~'d¼1ú@Ý´|*w´¯ôîxü™ò½Â˜BÖ˜‚ßÃñÉáç×3αäs;cß_ÆêÚSa0¦¾“xAä6ÇâO;z#Çú®{½Gü¦iñÛ–ˆ(bq] 6 S¢ï$ÞHz×’‚.E»ŒÞHš¾ë&ÀÔ®ü>f”8‰dop¿Ê˜Ž²m bÀ´R6îI“üæ°q.Ò`Øt­·ÿ`š¿Eí?²XT~W¦cB_ÆÄ7E¼ôU´‹èë»nLï¿iVüfb<&ÂåX– T¦cækJJ$’›£\¢ŸvôFÒô]7¦›Êïì#ˆèƒNVHÏÁ˜’í'ì·ÎJ«,Éö¼¢Æ/Õxf|˜¦Ûž8åÕhLðo—ÔÚ4`L)àWc’ÏÁ@+Ç®^&eôFŽõ]7¦÷ˆß4+~Ý÷©±Qƒ_‚ÿ»•+MÆ$pŽwÆ„w7¿éT´«è¤é»nLíÊo&ÉÉŸQ×Ê ÔèŽx̼t%ÅIE„ÞP ™Ôé=L“â·+e(©ßw,'ñ”¦cûL.Æä=Pnrì£h×Ñ9ÖwݘÞ#~ÓtÏo[•ita¹`L•iÀ˜(É·òÛ~€;Æt5ò.£7’¦ïº 0ÝT~KJ‘|“-ì«wå2ùU\o§CX¼Ä‹`.«­ýö’¡<ɘ¦+¿£ß¬‘“–ã›*Ó€1‰†ïìBÖ»öÍt•s—Ñ9ÖwݘÞ#~Ó¬ø­lMONü‹^9µiÀ˜(ÈWcÂÛ–|*ÚUô:i®{·+¿ýãÐ ™VÚvSðžßÙ u’.¶=ñ²N¶M‡Clz˜xVüö2S5ÂKE­\m0&¢ïíûóMI ÇŸvôFŽõ]÷&~øÍÓâ·Ol³m5Ù‹Töc.M#Æ$á{*g‹ýÍh¾í2z#iú®›S»òÛO4Þĉ%®jL‚Þ!Rj\ØúGo›Ä™ø3ûé1`š¿é¦høìÓ… ñ»4 “ßð¹fº©üæKÑ.£7r¬ïº 0½GüæYñrà"¡„rDxe0&ÛxàŘ@ïŠß˜~ÚÑIÓwÝ˜Ú•ß ˆ~½ß§ËR£8X½iw£‰aÕü£WÒÄ~»P½êIñ›§ÅïhÔ(+¿+Ó€1AÂïìBû˜îrìR´Ëèë»nLï¿yVü¶¯"["g>ÆŸý½Ä[šŒÉV³ï©p¾[ÍNE»ŠÞHš¾ë&ÀÔ®üÆœÙ6ž5å•^oc2Êc€Þó;ââ%^U‚£¤,&Ê’Ÿ¦ÙÊoû|®BPÞ.¨MÆ)Oå ßÊg9w½‘c}×M€é=â7O·=ñ†_˜Ùv©2 » è0]½LÊè¤é»nLíÊo[w&Û€ã[dLöCv0ÒC°6‰×“ŠO_‹Þq%„Giºç·ŸxÕ‘1Àb+W™FÓž%~5&#”wÀt5ò.£7r¬ïº 0½Güæé—–½‘…,ÍJÆT™Œ è˘âÝ•¹¦X–Ñ뤸îLÒ®üŽÁ/¤°ý•BZº’âÛ¯,¬G ޵­œ1¦Œ>œlÛCŠ“LW~gÛÖÚä]" `ªL£iÏ‚ßÊo_±nrì*ç.£7r¬ïº0É{Äo™¿mof‚r®\e0¦Èðíù%Ýœ˜È©hWÑIÓwݘš•ßà?, s—¼4î`LÁ›vï,àÉ‹ŒÉÞ/BQÛ—øè·'iVüV”ìÅèJÌÅV®2 §=Ǧ=ëÍ$ÁŸvôFŽõ]7¦÷ˆß2]ùíëõYZÊ))•iÀ˜‚æk5ó’ç›â7¹Ê¹Ëè¤é»nLÍÊoÈœ€!X¦KN‹ý˜|~žñ-gŠIÖ¦¤„ÿeµ¯r"où,cš¿í Às–PΕ+M£iÏÈðeLñî€ENE»ŠÞȱ¾ë&Àôñ[fÅo±õ<Ù ~ߣ`L¥iÀ˜lßñ=•‹1Ü­f§¢]Eo$Mßu`jV~CŠ>C+ƒÚýc‚¤ö–x“óœ²,žÊÙ›¥>cÅ»1`z²ÀR¦{~S°­=ˆ7){~—¦Ñ´gãƒc œïrìjä]FoäXßu`zø-ÓmOìëMÉûR'•˜JÓˆ1%øv°ŒwÓÕˤŒÞHš¾ë&ÀÔ¬ü‡x³¶ø™j½Â˜Xl'èB¡2¯Ð­ƒ1ÙË›ÉöÕ!ÇGÓ´ømäÊ8¼--(Eåwe0&fúNâñç&Ç.E»ŒÞȱ¾ë&Àôñ[^Ú¶4‘m–þSe1¦„ñ˘nV³ô;Åòoô:i®{SjV~ƒ~³úœk㛼TÕ>K[Á‘³O­ZcLÞ.z_FHð 0¥YñÛÀÕØy_‘²çweÍ.ü§VN#ÞÌ.Lñ§½‘c}×=€)½GüN“âwR[‚”lïN>àû¯0YšFŒ éWc ñFüNðÓŽÞHš¾ë&ÀÔ¬ü¶èÍÞòJƒ€ƒ1±Œ ‘[ërL¾.ÅÌÁÇÊ> LÓ•ß1ú²ÔöãEŽU¦Ñ´çD_V®áîoºÊ¹Ëèë»nLï¿Ótå7jI²Ï“þ˘JS5‹JáÛ] p¸&ÓUÎ]Fo$Mßu`jV~Jû/ÜΖ®¤øy“±mæ¼ ÒRËCÝrdòZT#˜OV~§Yñm†¶? ~÷¯Ð˜JÓˆ1QøvIõé{79v*ÚUôFŽõ]7¦÷ˆßiºç·K1¤D¶¿.NåJS53j¯«Y1ܞʥ«‘w½‘4}×M€©Yù½µn”L‰ãÂh8Ošh˜”ÑoȸRõ!):OÃàlKl{’fÅo´m¾wm×\LI©LÆ9~ûÊçw[¹SÑ®¢7r¬ïº 0½GüN³â·FDeåè×þ^I)M#Æ”¾ŒÉ¯Û¶“æT´«è¤é»nLÍÊïè­Þ “r$/ ]cL‘•€ƒ@N!ÇŶ'Ñû1ÊäMôQi¡ò;Û‹@¨4¦Â4š]˜âwO¢»ž_é·œûoôFŽõ]7¦÷ˆßiVü6’}°¢í°ñoÒÔ¦cúí.}Hu;iò©hWÑ뤸îL¹Yù°øÄI{“B^Fàg=®ßx[Þ°8%Å{0€½aÇGLSž¿½Ë¿±·d_[¹Ê4šöLúÏ´ç»Ù…ùT´«èë»îLù=âwžïùí}¥-ÉÈ+DþjL¥iÀ˜2ÄëÄÄ’ãh$Í·‘w½‘4}×M€©Yùý\’Á·q¶/oò›†|8‹qÅ긒ÂÙÛÓ1 3<¹•˳â·w  ƹÜÊU¦cÂßÙ… î^æSÑ®¢7r¬ïº 0½GüÎÓâ·pÊÎI0”­u+Ó€1%M—Ƥ)~„ðFÒ\Šv½‘4}×M€©Yù­‘²$a`{}ŽÃÊ‚1…À¶4*Wû1¹âžƒK¹â½bždLÓmO%±ý*Lô÷vAmM{¦_SR¼¿óÕˤŒÞȱ¾ë&Àôñ;ÏŠßÈdë³@Ì9ÀT™ŒÉ;“\Œ‰ÝÓ©hWÑIÓwݘš•ßÉÒ;ú4Ýä¤IW€éÿþ—QÈ[½D‰ÀqÕü£÷îpŸ2æD)=yW.OW~Ÿ¬€¥¸Ä[™µršûÊûÄø`ºÊ¹Ëèë»nLï¿ó¼ømK»ß§r•iƝ%¹¦¯¢]Do$Mßu`jV~³A³Ú â½Ç†c'ÿ&x3¦äýK%.<|T~{IŽýÙÉÛÅÁ“mOòtÏoÛ#©WVû)eÁ˜JÓhvaú’@Ÿ]x§c^¼Ëèë»nLï¿ó¼øm++0¨æ²çwe1& Wå·"~F9ÕI£_E»ˆ^'ÍÀu`Òfå·Ãù]¹h°”†c'ÿ2&oïš²ŠŸ_ócŠàm èJèÉI¼:ÝöÄ{ÖÛ˜‚ýV©2¦=sújLþd˜ôêeRFoäXßu`Ò÷ˆß:+~{ö$ ¨RåÖ¦còiCçj–sþÜ›k$Í©hWÑIÓwݘÚ=¿ BÙ/–dûçG£Oòq•DÞV‘ bÖ“7ŸQïËÕØÚ““xuVü6æ™ÄkÛ°FP™Œélzþ¢tØôT´«èë»nLï¿uZü¶ ‡¹kŽR6Š«LÆ$”¯Õ,g½¿õR´Ëè¤é»nLížßÁ(^¶ qGúÁÏ3&òæSêµHAÏ#ñÆäÓd ÑähGÓfV*¿ÕöÔÞ` æOSßÇ€i~॑0¼¬¯=U¦cüÕ˜ŒÞÓwŠe½‘c}×M€é=â·ÎŠßh_‰Ú«øãð/0•¦câÏžå`LAñŽ1Šv½‘4}×M€©]ùí5ÊÉ¥6û[–ʼ5Aò¾'ñ|ŽÇDQ`H·þ 0ÍŠß)fµ÷^X“[¹Ê4bL¶åú2¦oNåTÚÑ9ÖwݘÞ#~ëtÛ“¼Ö•S¦¢%Em0&’oïû£!`˜(\½LÊèUÒŒ\·&ª¿ºO?¦d?²mÉŽ> Ãj¢²òmGáC;ŽŽ kŒ Ôö80òpùÿLç×3‘c‘Яa³íOSÑZ§2þöü¢»aâO;z#Çú®[“ýo¦óóžH`ƒ2{¨,°,MÆ„é{b’Â0}§XÑIÓwݘšâwÊÆ“朓ÇN=¿'¬‰b3 ¯»Œ‰ ÁmÝ÷qê)<¸•;¿žqŽ%±})Tf ©,(MCÆôÛWÞáÝÓ¥h—Ñ9Öwݘ^#~ŸŸ÷8iŒ¨7ÓöÛh±xYšŒ áÛ)ÙKÙÞÊQ¸í2z#iú®›SSüŽ>‰WÓ¡ŽEZ¿c@68cï§ të`L^Y¡Ĩø¤Æt~=ãKd<ƒDÛÖjQ.P™FŒ)æow2:yLg9w½‘c}×M€é5â÷ùy“&‹·K4H±õ½êù]šŒÉV›ë®œèÝ]9 W#ï2z#iú®›Óøí ‹b´}ÑB)Ò±•‹!¤†L’1,• |ôáì býñXÝú/À4_ù-^·ˆÄ†™©2 “áÆwv!Å›r˽ŸvôFŽõ]7¦×ˆßçç=NšŒ`ï¼ï­ƒq’Bü.MÆJ× ÑS¤l$Í¥h—ÑIÓwݘšâ·t à-¤(æñ†ª¸Ä›Rp-–¼Í«.• 8cB°78Ù§¥Xž_Ï8ÇRN~•DXªî¥iÀ˜¼üâbLÈ7ã›(œŠv½‘c}×M€é5â÷ùy“&ûXDÍ!pb*®¤T¦c¢p˜ˆ$¼¦x•s—Ñ뤸îL±)~c †¶% Ño®¯1&`Œöœú,] ÕS¹È˾ %Û˜ EÙ;À ÀT™FŒ)}¯ÿEo~L§¢]EoäXßu`zø'Åo5žƒ~dTþnåjÓ€1ù1&ÛŠ„`ú(ÚuôFÒô]7¦fÛÊ$ÙK‰Õ6siQcB9fUg1/Þ•ó‚sÉN×?3Û¦Yñüm—¼b*º T¦cBúÕ˜\M»¦SÑ®¢7r¬ïº 0½Gü޳âwdïw¤üÄ_ÆT™FŒ‰¿'& 7âw<í*z#iú®›S³í‰ßã ÈBöC‡¼Ô]À¯¤xïÉ`¤)0¯]Iñw×p‰À ðìoü0ÍŠß~¼¼Ý‚H©1U¦còšø‹1ÁçIJL§¢]EoäXßu`zøgÅo¶…9D{bŠEñ[e0&ãÂWçoÊâ©hWÑIÓwݘÚmO„S ‘’¤µÊo£[$ˆhànŸ‘§ÕÊo&µå?Cæ'Oåâtå7†€¶Ñ÷²bàee0&C¦owoLW9w½‘c}×M€é=âwœ¿3°z#òJJe0¦ |Uårjw°µü§½NšëÀͶ'E}ªKXip0¦,’Ô ¸ uUcò!6½jã†+ÿ˜`VüöÂ{júࢵne0¦h‰p1¦(7ã›NE»ŠÞȱ¾ëÀï¿aºòÁv mçPÞü®L#ÆÄùê`i»‰t£1ÁUÎ]Fo$Mßu`jV~ K‘(}ºÆ˜|Àw0rèõî¬ Õ™gA´Oui‹ò£WR`VüVû9‚DdoUlåJÓ€1Y’}'ñFâ;`:í*z#Çú®›Ó{Äo˜ïùí÷²ü=P¶=)M#ÆÂ5”ƒu§ LßFÞEôFÒô]7¦få·ÏFùŒ`ò9 ‹ŒÉ'ƒCáìH¼ØÁ2)ÛSÞ…æÙ+)0+~û Y&ÃKtŽów+WšFŒ)¤_ÆDÜF`üO;z#Çú®›Ó{Äo˜®üNY2Û#@eËÊÔ_Í|d¯`ä¯V¾ÛÊ]åÜeôFÒô]7¦fåwBŠäÞÈRÏo£[Áçd¦¬Ç@ÞEƤh˜¡bòA-úà0‚óëç˜Tù6Úr°¿RX+ø?Ûúõ_ìcVdñT޳¨&E¯ËypÁùõŒsÌk3zC²Ï¢Ð˜JÓ€1Y^]¬<½COp5ò.£7r¬ïº 0½Gü†é¶'~óAÕþÉZSeê¯fÇ%Œ“1QŽw•ßxõ2)£×I3pݘ°Yùmè€xTG'Iãúë¿I“ – Í Õ8§ºu¼„h3i“øà$ÞóëçXòÁÐÊ_³6¦=KºúÊGç•m`ÂSÑ®¢7r¬ïº0á{Äoœ¿Rò×By”[›ú«YÎt€‘3&ò;b7Àt*ÚUôFÒô]7¦få·"ål;Ïä÷Õpu|SÛ‡ù 1¯nå“O@ðæôéÜÿÐÀËóëçXâ(Þ‘}öç`ªLÓ› S;`:í*z#Çú®›Ó{Äoœ¿Œâ3Ð `ªLÆ$šðbL"tS`‰§¢]Eo$Mßu`jV~G/бmGÆÄr+/ŒÏê]»^ìw΋âЩGÀQôÉñMç×3αD¶'¯°JcªLÃiÏzÝÇ´)Ü-~W/“2z#Çú®›Ó{Äoœ¿ý mï $eSe0&ü\8¥³Dð¦ÀOE»ŠÞHš¾ë&ÀÔ¬üŽAI³ëy7I]&{åÄVm§[ªFÛž¸ Ç ™}+ù$0M‹ßÆF¼)€1ÁBü.M£Ù…9|§=‹Üüâ¥h—Ñ9ÖwݘÞ#~ã¬ø-Þ¶Çh1”­u+S5K¶HóŘ®«¤9í*z#iú®›S³òÛwb¤ ˜A>så“wRðF¯>öÓ¢xEüöÑhJÇ€•GÅoœ¿éhÄ›#»ÿWü.M£Ù…1ýÎ.Œ·rÁ¥h—Ñ9ÖwݘÞ#~ã¬øBê§Ú)²–#ÂKS5³Å,}SÌ|S`I§¢]E¯“fàº0Q³òÛÄ)ØúàÅê‡F»À˜¼M¸×nÙþÕ6¯<ÿðç6“KÛjô½¼xûð&š¿C"qÙZÅ¢Q\eÍ.üœ$Œ)ä»û˜t*ÚUôFŽõ]÷&zøM³â·¯¶ºÚɾô¿ÀT™Œ)åœ.Æt6!j% ü´£7’¦ïº 05+¿£­ìÙoº©p8Zë.0&דּª+T—€É;ÎCû6†'iRüÎ~Jh ½;r)”¦ÑìÂð½iúSlÙÈ1üiGoäXßu`zøM³â7 jad eSi0&0Bs2&ôí×MÒÐO;z#iú®›S»ç78´köýÜ*cŠ^ý4Fõ=Æc²)Pò׋òÕ‡æ!`š¿ÅkªEsÒr+WšFŒÉhäù+e/k»É1þiGoäXßu`zøM³â7ße²…]Šžß•©¿š‰‚\•ß¶Ò‡;`:í*z#iú®›S³ò;‚ñGðÞH–îy\aL‘¢·î[À”óƒ1­3ɇªÇGÓtÏo¦£ý s.º¤Ö¦Ñì„WËÌonÐÕÈ»ŒÞȱ¾ë&Àôñ›fÅo{oR¶°CA³+S5“”5]ŒIð®ç7Šv½‘4}×M€©=ðÒvStì@½\–S£DBrŽ Êù¡1ÛÃ%I„è4õ_€iVü¦ƒójf¯fÿ L•i4í9ðõ+ùÿæä—ô§½‘c}×M€é=â7MW~Ûv(d%(ªrkÓ€1I< ,11Ý ¼ä«œ»Œ^'ÍÀu`âfåwŸ˜nŒE‚áR\Õ˜äÿ_w×÷#Ç£ßýWôcæÁI”Dr}¸Ûć;,nƒœûhŒÇmdöŒ13É÷×Y%UWKª_çô¡ÐFd,G%±>}¤(2"8áŠ~Ýê☇Öirc®¸0…Õ9¿æƒ'#+☪¦ÆäO‘ߨYe&t,'ò.¥7tl¾ë>€)\ó;¬N{‚¬ß{Ó!ÔuåΛ“£.©Yǘ Æ šr.“RzCiæ»î˜š‘ßV#c4Y›Ò&`ÒS9'\Ë #EÞx*§™;‚n0Ãr àï¦ÕiOв.¢ïÊUž§=)›–ª={È·lìÔKȹLJé ›ïº`ºçwXëüÖê£Là5ö¥(FP5Íïfzù‚3c²aê(7$v%½¡4ó]wLíÈoÙ‚ odL2¢ìáZËlŠüîÊ­YCAæäñ‹2¦ÕÎo=£´ VÅòoٴĘì c )Vž=Ú¥ô†ŽÍwÝ 0]ó;¬u~á"X#•©¦¢i~7Ó%ä«Y`¢Ÿ81 ñ¦-½¡4ó]wL‘ßžP8…g­€ÛéM;ux°¾ûÆ –>jÕ⨙o1B¸$0­t~“’…ÓK6>,UÓRµç¾–\ǘ †ŽáM[zCÇæ»î˜®ÇùV:¿±sep îå‚f—M ŒÉƒÏ§rŽ MœÊºiKo(Í|×S;ò[Ë›R‹1g‚Ùx*G‚D§——»ÓÍ Œ •mÉÞ¯…\¸(cZó[=f5n´pÔM Œ r–TõWO™r9‘w)½¡có]wL×ãükß1!²ÎPqó»nZ`LÆPHŒI¿Ç‰Èï˜<Ú•ôZiºî˜b3ò›½f¶G-Ÿ`Ùn¬+‡ÙX#LKÓÅ-¦í.2X¯e‹#²-ҭ隸ÒùMFgÃýS©Ð±ªi‰1y›ÝfûfâT.Ú›¶ô†ŽÍwÝ0Åëq~ÇÕ‘ß‘|ðòDùˆÎ•¦jšßÍ|$70¦`¦hvÌáÜ¥ô†ÒÌwÝ 05#¿Ùºž5’ØØ€-}>&­¦«¾Ac6ú˜œµ–ºNn÷‹Óê´'Œbкˆ å•”ªi‰1›#¿QstOèXÎeRJoèØ|×Óõ8¿ãZç·¨—GÑd ¶¬+W5ÍïfºÌ˜ìcJíJzCiæ»î˜š‘ßšØËGÄý¦Dqo5T•™œ4Ú}K‰•>çw”¯Ww ^²A\íü½C àÜÇT7-1&ãršÉ”˜=Ú¥ô†ŽÍwÝ 0]ó;®N{" ¡9…“œSÕ´À˜ôŠWfL–ýÍιLJé ¥™ïº`jF~«ƒ }D½V®ÜƘ¢æÕ•·6¬!–›Rë¾í+g“ HÂ/Í"Ýú`Zù­näÓ7bYúòoÙ´À˜š“&6Ÿð1ÅÎ]IoèØ|×Óõ8¿ãê´'Z³•d{¶ìŠ‚—UÓünìh`LÖLÚÿ9—I)½¡4ó]wLÍÈo1?eÔΪ7Õãÿuǘ¼×8&‚if[ÁK=Q7& Ù2òëû –¦•Îo’¿öF¯zCå©\Ù´Tíy¨ö h&BR"ß´¥7tl¾ëN€ézœßq}ä·Öò%fòeù¦²i~7ƒØÇ.)c²¦ª¤àÎ]H¯•f¡ë>€ ›‘ߤyKHó …‰­ŒÉ±þ«õåDÐFÆ[@FŸ’b_˜puÁKDGhhnä”+›“EÌ,Åbå SsËRzCÇæ»î˜ðzœß¸Òù͆À óçPœÊÕM ŒIë˜&Æ$›ŸRšÞ£]Ko(Í|×S3ò›4¸5‚óÖn®’‚”÷tI¶Vâ júàµTÊ2$~0­u~GAJ#[•‘e40•MKŒÉ õ–h”ÃäÑ®¤7tl¾ëN€ézœß¸ÖùmYôß©3ƒËJ¼UÓcr¹JŠ•íg"À“G»’ÞPšù®;¦fä7«ÑÌb‹õ©©61&ò• F'4qSÁKÍ Ž5HÞ9²Ëªï¦ÕÎoînÈjúZW¦=)›–ª=÷'¿}F<ï&bå0{´Ké ›ïº`ºç7®.x<9 dÕëWø˜Ê¦…š_B’rä·°?¥4¹Še)½¡4ó]wLÍÈo-t©)75žXàe#cB-…-¦ c¡]›ª¤èÔ±wš4žÉ\òT×:¿ Á!G«tŠËªi©ÚsÊZ¡ŒI(ÓÔæ—<Ú•ô†ŽÍwÝ 0]óW§=!ÎEOà±Èù]5-TIÅSv½z>eÊå\&¥ô†ÒÌwÝ 05#¿I )£g< {ñæºrJj¬ÆºwÅ„¶Þ• @,3F>^´D8®Îù-¼1Dçä¿Tú˜Ê¦%Ædm¾+§Õ©&X0'ò.¥7tl¾ëN€ézœß¸Öùƒ¢VËŠ\9uÓcòd 3&paâÄ„ÌM[z­4 ]÷LÔŽü¶ dĪÝècB0hž,ª«hcù&+lÕFƒò6,—Xù`¢ÕÎo0b ù£àK`*›ª=G1¹’Žg§®=Qöh—Ò:6ßuÀD×ãü¦µ‘ßôî>ÈînÊ´'UÓcÒ-:3&ç¦,)…sWÒJ3ßu'ÀÔŽü[Ö¢Ñn1>6žŽ1E"b¶QÓZãÆòMz´d5EºEˆ½+Gkßb(ƒh"DWd°¬šæuLCáóíõSO0&JíJzCÇæ»î˜®ÇùMkßú½öbácªš“µ~8•ÓÝ ¥IíJzCiæ»î˜Ú9¿õÄÓ«!}*ô-Ù¬u6FÄj0mcLA/ØE±{1h¾¹KÓjçwD±*=jù­òT®lZªöº»ƒ}µg¤)Vž=Ú¥ô†ŽÍwÝ 0]ó›V;¿Å:òè´äqLUÓR•T´&íf,¦DÓÔPšìÑ.¥7”f¾ëN€©óÛxÁÐ\mí¦´'¦ÏfíÕ‰ín ‡.––?@²ÄÞ»K&Š£µÎïhËž"„„±`LUÓBµgM»—tL&ÈMø1)y´+é ›ïº`ºç7­u~§¶:C€ªJJÕ´TÁ‚0ŸÊ±±ÝýÑ0%v%½¡4ó]wLíœß ˆ…ºHl*ß$°îŒ3þM6U`ÚÀ˜Ô·¤^\ÔjáiA&þ`Zù­nj±ôƒ,dU†¾hZªöÜÇ1õÕžûË0åpîRzCÇæ»î˜®ÇùM+ßÈdĺ–mV/1žïfUÓRvAc²ý¯ž[ß&67méµÒ,tÝ0q3òÛ:Œ†IÊ>¼¹®œ 19-˜éÀlH™Â4\<k" YÕ&þ`âÕÎïèŽEÙYŠáUÓc‚>NϘ,OdàìÑ.¥7tl¾ë>€‰¯ÇùÍk߀N¾w«—M].P5-Eå‚ÉUR´žiœ¦äÑ®¤7”f¾ëN€©ó[“´Æà-Ê׳¹®œÞÞã5š(VìÆºrÞ:Š]ê{ò’%Ây­ó)ãQH¤†tSÕ´À˜L9¼cLÙ·ßбäÑ®¤7tl¾ëN€ézœß¼ÖùU‰x4çöÝ´°›Qðz.ôë3b”ãäÑ®¤7”f¾ëN€©ó¢5½žÛØT¾I|`£ž¢¨7%¶1¦¨éN\—¼½ÇKÓZç7ZM-…^–ÐpLeÓRµgïs¬œ€þTH 'v%½¡có]wL×ãüæÕ/Ù¡EMM-ÛÅ90UM UR¢ì€IkL8¿9W±,¥7”f¾ëN€©ó[˺‰=¦AÜ·2&çŒôÀЧTÚÀ˜°K´b£Ì‚¹(cZëüÓ2h¼€-Îïªi¡Ú³÷6ÇÊycÝcJíJzCÇæ»î˜®ÇùÍkßÈB4½ÉqLUÓB>&pÝQ®2&ÖMù˜’G»’ÞPšù®;¦vÎoß]~goÀ1o<•Ó +ÁjîM¹nuÎo1EDå¬äø’Åxmä7i´NÌRËeÁ˪i©Ú³ÈŸrµç8•(ŽS8w%½¡có]wL×ãüæÕ9¿CôêÑ@ÍFsLUÓRQHŒÉêŽÝ¦`r"ïRz¥4K]wL¡^ºž1 :è¡¿Øqv‹5Ö3¦€²†¶K¿­àåÛ[ΰؑVÃÎ,ÓHiÒ|/+ b$@ãÄÂF_œ˜TM 4[Ýp‰–nh"M0¹,e)½¡4ó]ÿ_‘æÏâÿå·ÇÃç‡/Çîý§ÿÿôLÿÐÏÏOÿ}ìFpxú|øýáùõ7Ùb^^ï^/Ýóßž¾Ü=?üO§¹‡OÏ©sÖ‘òt¯æ¿úåøÃ»›ÃÙŸÿ:þ«wòÊ·‡o2°[™íÿëÃø7‡»ÇOÚ9ÿü¦ÿ(ú‡Îk,ƕᅧÃá­2Ñüö]²5s(ÿ¼ítÒºîYù?0ƒD—Ú½S¢ø!ITFðš)qN¢ƒ,Ññ òA¸9w™¼MÿjÐsŸÞ¤–ØÉ±:Æ^vª¤}úz$Z†Ó£ñ}J˜lcú ]žG5-Óºè–4]Á7ìNošc ,Ü.ËN™ä\žGm'MM ù­•ç8]ªÅ×£Æh‰yõú‰ôá“DèrbŸÖª’hÙQ–hà Ñ+A ›ÓÊhROvne`X™t…#}d–×$HóØk°J€É1²õ>Ñ…AbÖG¶Íé­µˆŸÖ˜”¨×òM$B’hÙ"…‘DÍm¥G¬3oüðõœ$f}æ-:é£ìbQ`û›éß5r!ÑNúh ‹BÚÞ(îÇèôRÔ™­µç­½u¬Ú#ÿ'8 OóhbŒŽN+ÃàuS5ùoÊ1:!—ØQÆâ‰YÕ‹Á¾KRœ´Gh‹ü4%Ñ8’D#ó3HÌúH6¥Ñw-_­ÓìB]8M{ý€=ywýI@S°»â/Æß=¿>Ü?|»›€ù×§ÃÝÇ—§ç]ûýÓñóç‡ûããkÿôÞ«ß?ÿðîö—›çÖïýÅç´)°wáMûÅ™ä3Æ&dÐÕb+“Ë>ÍĬ#¼îvŽÆ¥¬Ký³DÝÜégó—À¬—ÎRÑ€~MÅ^qèû( À<~6ë|Ô«ð6åEéžØ[ßsbIÎÑÖ‘Ó{>î„¶Üïn<æì@áª>+ ÈŽ¿Þ ‰cŸÓ.önüìð¾ÙçòÂýnGš;b˜ùƘóûº˜]Œ§g|Yž?›çœ#d„Šýû¢&õ½¯—U²x¶¾Ù™s޲Jp†VA ѵßwŒt´@ §Ó˜mDÙÔB^ñƳÃû-(…8š«àe¦Søüìð¾zu!'Q4#¥¿ê¯h¨AŸÑ«);~vx_BõéúN8™¾n—²ñøÙÙ#1p°§¹Š¼‹!ö“€çì÷úá÷ ÜÚTH±ŸÙ§[H…n¼{x|xùõøéðåáñx7&•Ù;ñôx{{ûæ0ÐÞ¯w‰$ª¹#@(òðåð—Ÿÿ®?:G‚~/‡üË_ÿzø! Ϫ´//7ƒŒ—§/¿?“ ¼Ð,£û‘aVÆÓãñƒš £qxw æ4Ëòšc^l™AÆ9‰¤hº,ñ E&]ða,…eÞË·é ¡ü½ ïUé² o£-FmOiF¼Ãn ÒŒø€²çLÊøãÞæ×ß^ÒŒ÷#¥É8Ú[2K3¢ÊóAí‘ô6Æv‹‘ßFÆáÏÆå/e<=¿þút‡Ìk§XYGl¸5¡‡9“1²Á’ çäŸÞE¾ŠBFke>‰8šùHoq4ù1ÒH†þP®Ìßÿëðüô›˜pÇ—Ó'ðÕ¦¹Nbð‘X'>9ͽ”;>Ê ~)dKŸÇûó!ûN{FŸ—+¤ž1Ÿ¿öçÏù³ aè·î¤²AÖjÀ¥ŒžÉ°I,¦áÃp "ÇÓô^|½„j§¾‡w‘u§Ñ»È0»„Ÿî~¿x:Ÿ3VÇÎ)à}1×´äçãx²û†oO/¯o¿=?Ý_^²xùDèl)cˆbž‹ÿãï~~? üW«»Ïi¾ñëA€•{1oúÇÞ«Óäù·ÇÃ?ï„ꟿ><ÊD eTG”u²ø'ˆòëí»ãG×Ëß7oþüöýógÑüí_?þí?ºýã¥ÿ/ö¿‘ìŸ(TDDFPT/Examples/CH4-BOND/Makefile0000644000175000017500000000155312341371500014437 0ustar mbambainclude ../make.sys NAME = CH4-BOND default : all all : stage1 stage2 stage2-2 stage1: $(NAME).pw-out $(NAME).tddfpt-out $(NAME).tddfpt_pp-out gunzip $(NAME).pw-ref.gz $(check_pw) $(NAME).pw-out $(NAME).pw-ref gzip $(NAME).pw-ref gunzip $(NAME).tddfpt-ref.gz $(check_tddfpt) $(NAME).tddfpt-out $(NAME).tddfpt-ref gzip $(NAME).tddfpt-ref stage2: $(NAME).tddfpt-out-s2 $(check_move_cube) s2 gunzip $(NAME).tddfpt-ref-s2.gz $(check_tddfpt) $(NAME).tddfpt-out-s2 $(NAME).tddfpt-ref-s2 gzip $(NAME).tddfpt-ref-s2 stage2-2: $(NAME).tddfpt-out-s2-2 $(check_move_cube) s2-2 gunzip $(NAME).tddfpt-ref-s2-2.gz $(check_tddfpt) $(NAME).tddfpt-out-s2-2 $(NAME).tddfpt-ref-s2-2 gzip $(NAME).tddfpt-ref-s2-2 clean : - /bin/rm -rf $(NAME).pw-out $(NAME).tddfpt-out $(NAME).tddfpt_pp-out $(NAME).tddfpt-st-out *.plot out/* $(NAME).tddfpt-out-s2 *.cube *.cube.gz s2 s2-2 TDDFPT/Examples/CH4-BOND/CH4-BOND.pw-ref.gz0000644000175000017500000000617612341371500015644 0ustar mbamba‹¹>OCH4-BOND.pw-refµZésÛ¸ÿî¿ÝÎìH­Eóí¦3©cÇ»ÍáÆIÙõ@$$qÍkyHv¦|ßÀÓÔ&Ênè‹‚ð~xx÷yBðº.²MÁr}{s~Ivš­ù>‘WY±¢*I–ýä+S7LÂ*ø²$ÆÒ°Éɉ˜ö~•$W0x T$[“jËI–ótQfupòU‹›ëw77oIYG—ë¬ ¿©ßË(©cVE°. $¬âEÄâò’Çœ•œ-^ß]käeÄÒ4ûô)"¼",ÖNÉϹÞ>–Úò^.v<Sš9ýI0KÙE”¶’¦Ôí–7R1]ßq7–í{…µHŽÞÿ4l} ÉÜXT·E$Í4ÛvüÞ§aèþÈ´\‹n<ÝpU„ͪÞ<Úÿ¤”ž´8ªb¾TúxÿâÅåõ{r~e“÷¼¬„ÙƒfåÂÜÆûøÝëDᯠ¶cQ¹€à Šã âKa=ëO7äìf¤–pŒ½3cóv¶©kèØ`bZ­<±N£jp0¯ØgÂ;P—`º¤™!Íü¿Êµ»à±¦<O£S³Á— A\Ï6dzy ²+0ޱ=­‰OÝìeÛtq³e"–T¼`+[»R2Zð”›GÔU¶^÷±-ªDôîQR[Vl¸p…¨š Sd)$ pnPEµ…”²Íâ°¿†¡é Ý‘³“è#á ò^ ÿºæêOw« £ÂP’àyÌ”‡Ê$ýÅì'ÝðEA¢Q9¿YíæÕsðï_àË›·/?â¿s2#üéø7W?.Ö›0ê–”ˆ²`4Œ0™óg­ù¡¬Ô°‰Ãäɰ5ÙÓtzØ)¤â Âë‡07ƒ$Ri ´¬5ŒØè"ë ß'[ΤÕj½…»[p»§ÄfCÜ£˜Â™$¶&ˆ§pXR»°ÒøÜnM’Gg“û]µûíØÔŸÞMð»j7ÛÍŸÀ˜¤´žPN`Ì»8y-Š‘ë ¶öW0WŒ¼ç¸{ÊâK•]5íL–.gç½Ò@e¢ü÷P('KÂVÔ CÇ´Vk¾rý€2w¥SwøgÜÔûkcþêp,È™Å<î”üé]”SššûãĦ¬IÊ÷M< ²ŸbE+cN¨2|áV’¦fý ÊÛJ'€ÝQˆVJLHp²~;áÈ@ÒÔ8PCý°|"aKµ‚\§$h ^}V‚WŸ“ ¯¯x°ò=ºr {­ûuȵ¾ëû^h:ÎKÐø–4,£“ ~@‚ª6VÖ„"ÐÕ°R&ªQiÜ ÿ|¨° YÝ(‹Vsfâ{çˆWC*cŠêª¥Rd¹yL4ò6‡>l–‚lSÕ·ÌAu E¤˜yÑ€—Ðˉð ˆ!Ïq’jí~ǶÌ`ŽŽ(0dé…£77]±ZÌ.~Ù®i[=|ßC3{hWZ/”Rh0 Q ¸ï¡YÓh½Øj†ãÛö“{jYæÐìi4»Ï›¢:„ÜC£Óhtš·IäÆzݲmU®< ê:T^h©îgd¨IýI*ÜC‹¼¿‘Æl†‡/ds^ˆÍ†a¨JttÏbÎååû^+¼Ä%]zÚþk6û K´"bÈuèû¬(أĀ4°éOZöÕ\ uí¾ºâñ¶×#6…'nÈ4È땸¶ìRã¿xþÞ¼zÚ÷/Š5‰at,Ø’ÿœÛ pÿ"Lõ0<§‡A“ê#êF„R#Œþ. Ë÷쎺%,·P> yWüe×|¨Š'yV°âñx <¯¢8BÒý ؓҳÌÑþ˦¿:»Áì"zè0;°ÌÓ úó2º‹þ‡iàî× Ьû< c+x.7޵¨êûîr4ðÙ‘O%„Äø <óSkEꀤÎyÑD^tìuÁ¹l¿ÔÙæÝ%$Å:pÀÃD\[¶0èƒ €m»Vê‡SpÈÕ|HÎîiw.RÊ\Jd×Õ9p»nsVç§$Ìöé|)Ì̦Ðâ2\ü½)âošõöë@œ¢ (äã4„´ú ýVæWø¹ÉFU†µzפ›ÁÌ›BÂÉ‘£4ÛcÑ .[óHÉ[º¯E)•(FHuq 9ÕŒ¶ƒ‚ŠG¥,툓¢ „ŽNŒ¢%<Ã.L.¶‹ÂÈÆÇ=X) mÌr9•Cÿ§ÊlùÐÜØnë 8U"~^¬¶‰b5{b=RHþPH’N5ÃKf‹…A5×p jCniúÛ+pí¨\\fu|5xw„GÆ="ôïzŽÞ#jf…¤  µ ‚ZH±æ¤ñ-ÇðlJ=‰&Td~S¹škl­Ã*2¿HE¦éü!¶FU‘G=ˆw”ŠtݧPm™G©Èô jxî!YßTE–æØ†ŠjŒýõ*ò4óXùXŸ¹¶~„ŠÈ7,—§"]·-Ó ‡TdSQÍÆ@G«Èû"A úC*2‘ãUäz ;z¤Š\Ïuô"Ø“AuK? "úMUdhÊÖùùÈòæ«Udé_§"ð ãh™¦î«"]÷,÷€Šœo¬"ó¼û%î‹ÅmSÿE*?ÊQ™<)“Ä…-œ:ç~Ìð\÷Éõ->N#+(åJ2ã»ùRc¢¡¶Agák¦C­æ’ùƒÄ帢*¥–jd]Ç•ý£o[²‰÷]ßT¬l£Í»Œ T–G<<%q¶Ç:m†HÌw<–hiV99ùËqÖ<km†ïWùÈÆØ¦µ½ßò! H|jXÖIóqA»»ÇjL#)—Š2Kù¢yp‚§aн¬äƒGŤåƒmR‹Ú¦Ó2 å…íÄ`~OxvO¨}£ uÁÄü>Ѫ ª:ßíÅÇ=‹ÃIºæñØ5¡»³ìNýg*[V‚ñd¹@ÛøÈ˜ Kv.¢¨n ù:«+|Î2<ØÃ§ÂÁÖ^ä…VB£yÒ¾^UwE-¹Y6Šñý’œ_P2€æ©$·Ï_½jš?hÀaâæìkð¼Jb4ì†éi†~CµqøPWo6,©sWhŠp„ 94ûb ý»BO9aC ëK9l7¬X îdèû5;xðËÁ;ÁÂJû§¡"œßÅØÝeë;ÌYƒmöîx›î÷¢Ã Öã0cQ)Ñ,{ÖV—wæ|°IùµnX ¾ƒß|FØc{8Èàß$œbp{——‘"iÀ¡¦¢=pؽ?7ýƒ› ]øP“#Ms¸IÌšÛÍÃñZ°G‚2½C›ÛjÞ³û]]J¿TÝûÏ#bR@Œ‰R®Žb`ÊŠãÓ¡ý™¡Å×õº}áðÎ-{„áŽ1öc y Ec¨EÃï|I=ŸiÞ}nÀïÊ@¾äÕ»úÐD†ê5Í¡ _|üØCUˉ·œúLCÃåö­ªWx3"«÷aÄ;q¿÷0!F©Hºâm+ù5HコÞuròlê•™¯¿ž!G?¿ý'yñöÍ…öç£ÿ†=‹ÜI(TDDFPT/Examples/CH4-PR/0000755000175000017500000000000012341371517012602 5ustar mbambaTDDFPT/Examples/CH4-PR/CH4-PR.tddfpt-in0000644000175000017500000000016612341371500015305 0ustar mbamba&lr_input prefix="ch4-pr", outdir='./out', restart_step=250, / &lr_control itermax=500, ipol=4 / TDDFPT/Examples/CH4-PR/CH4-PR.pw-ref0000644000175000017500000002413512341371500014616 0ustar mbamba Program PWSCF v.4.99 starts on 12Jan2012 at 13: 6:19 This program is part of the open-source Quantum ESPRESSO suite for quantum simulation of materials; please cite "P. Giannozzi et al., J. Phys.:Condens. Matter 21 395502 (2009); URL http://www.quantum-espresso.org", in publications or presentations arising from this work. More details at http://www.quantum-espresso.org/quote.php Parallel version (MPI), running on 4 processors R & G space division: proc/pool = 4 Current dimensions of program PWSCF are: Max number of different atomic species (ntypx) = 10 Max number of k-points (npk) = 40000 Max angular momentum in pseudopotentials (lmaxx) = 3 Waiting for input... Reading input from stdin Warning: card &IONS ignored Warning: card / ignored file H.pz-vbc.UPF: wavefunction(s) 1S renormalized gamma-point specific algorithms are used Subspace diagonalization in iterative solution of the eigenvalue problem: a serial algorithm will be used Parallelization info -------------------- sticks: dense smooth PW G-vecs: dense smooth PW Min 1787 1787 445 113964 113964 14262 Max 1790 1790 450 113970 113970 14264 Sum 7153 7153 1789 455863 455863 57051 Tot 3577 3577 895 Title: TDDFPT CH4 Test for projection bravais-lattice index = 1 lattice parameter (alat) = 30.0000 a.u. unit-cell volume = 27000.0000 (a.u.)^3 number of atoms/cell = 5 number of atomic types = 2 number of electrons = 8.00 number of Kohn-Sham states= 8 kinetic-energy cutoff = 25.0000 Ry charge density cutoff = 100.0000 Ry convergence threshold = 1.0E-06 mixing beta = 0.7000 number of iterations used = 8 plain mixing Exchange-correlation = SLA PZ NOGX NOGC ( 1 1 0 0 0) EXX-fraction = 0.00 celldm(1)= 30.000000 celldm(2)= 0.000000 celldm(3)= 0.000000 celldm(4)= 0.000000 celldm(5)= 0.000000 celldm(6)= 0.000000 crystal axes: (cart. coord. in units of alat) a(1) = ( 1.000000 0.000000 0.000000 ) a(2) = ( 0.000000 1.000000 0.000000 ) a(3) = ( 0.000000 0.000000 1.000000 ) reciprocal axes: (cart. coord. in units 2 pi/alat) b(1) = ( 1.000000 0.000000 0.000000 ) b(2) = ( 0.000000 1.000000 0.000000 ) b(3) = ( 0.000000 0.000000 1.000000 ) PseudoPot. # 1 for C read from file: ../pseudo/C.pz-vbc.UPF MD5 check sum: ab53dd623bfeb79c5a7b057bc96eae20 Pseudo is Norm-conserving, Zval = 4.0 Generated by new atomic code, or converted to UPF format Using radial grid of 269 points, 1 beta functions with: l(1) = 0 PseudoPot. # 2 for H read from file: ../pseudo/H.pz-vbc.UPF MD5 check sum: 90becb985b714f09656c73597998d266 Pseudo is Norm-conserving, Zval = 1.0 Generated by new atomic code, or converted to UPF format Using radial grid of 131 points, 0 beta functions with: atomic species valence mass pseudopotential C 4.00 1.00000 C ( 1.00) H 1.00 1.00000 H ( 1.00) 24 Sym. Ops. (no inversion) found Cartesian axes site n. atom positions (alat units) 1 C tau( 1) = ( 0.0000000 0.0000000 0.0000000 ) 2 H tau( 2) = ( 0.0404914 0.0404914 0.0404914 ) 3 H tau( 3) = ( -0.0404914 -0.0404914 0.0404914 ) 4 H tau( 4) = ( 0.0404914 -0.0404914 -0.0404914 ) 5 H tau( 5) = ( -0.0404914 0.0404914 -0.0404914 ) number of k points= 1 cart. coord. in units 2pi/alat k( 1) = ( 0.0000000 0.0000000 0.0000000), wk = 2.0000000 Dense grid: 227932 G-vectors FFT dimensions: ( 96, 96, 96) Largest allocated arrays est. size (Mb) dimensions Kohn-Sham Wavefunctions 0.87 Mb ( 7131, 8) NL pseudopotentials 0.11 Mb ( 7131, 1) Each V/rho on FFT grid 3.38 Mb ( 221184) Each G-vector array 0.43 Mb ( 56985) G-vector shells 0.01 Mb ( 1880) Largest temporary arrays est. size (Mb) dimensions Auxiliary wavefunctions 1.74 Mb ( 7131, 32) Each subspace H/S matrix 0.01 Mb ( 32, 32) Each matrix 0.00 Mb ( 1, 8) Arrays for rho mixing 27.00 Mb ( 221184, 8) Initial potential from superposition of free atoms Check: negative starting charge= -0.039302 starting charge 7.99987, renormalised to 8.00000 negative rho (up, down): 0.393E-01 0.000E+00 Starting wfc are 8 randomized atomic wfcs total cpu time spent up to now is 0.6 secs per-process dynamical memory: 38.9 Mb Self-consistent Calculation iteration # 1 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 1.00E-02, avg # of iterations = 4.0 negative rho (up, down): 0.116E-01 0.000E+00 total cpu time spent up to now is 1.8 secs total energy = -15.61234295 Ry Harris-Foulkes estimate = -15.99276112 Ry estimated scf accuracy < 0.55905247 Ry iteration # 2 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 6.99E-03, avg # of iterations = 3.0 negative rho (up, down): 0.615E-02 0.000E+00 total cpu time spent up to now is 3.1 secs total energy = -15.73504884 Ry Harris-Foulkes estimate = -15.84223600 Ry estimated scf accuracy < 0.19881760 Ry iteration # 3 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 2.49E-03, avg # of iterations = 2.0 negative rho (up, down): 0.216E-03 0.000E+00 total cpu time spent up to now is 4.4 secs total energy = -15.77628566 Ry Harris-Foulkes estimate = -15.77835559 Ry estimated scf accuracy < 0.00405796 Ry iteration # 4 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 5.07E-05, avg # of iterations = 16.0 negative rho (up, down): 0.293E-03 0.000E+00 total cpu time spent up to now is 7.4 secs total energy = -15.77713531 Ry Harris-Foulkes estimate = -15.77718905 Ry estimated scf accuracy < 0.00013237 Ry iteration # 5 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 1.65E-06, avg # of iterations = 8.0 negative rho (up, down): 0.448E-06 0.000E+00 total cpu time spent up to now is 9.0 secs total energy = -15.77714475 Ry Harris-Foulkes estimate = -15.77715729 Ry estimated scf accuracy < 0.00002707 Ry iteration # 6 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 3.38E-07, avg # of iterations = 1.0 total cpu time spent up to now is 9.9 secs End of self-consistent calculation k = 0.0000 0.0000 0.0000 ( 28526 PWs) bands (ev): -16.9081 -9.3074 -9.3074 -9.3073 -0.4491 0.1311 0.4247 0.4247 highest occupied, lowest unoccupied level (ev): -9.3073 -0.4491 ! total energy = -15.77714681 Ry Harris-Foulkes estimate = -15.77714689 Ry estimated scf accuracy < 0.00000020 Ry The total energy is the sum of the following terms: one-electron contribution = -46.10003825 Ry hartree contribution = 23.71636619 Ry xc contribution = -6.06422314 Ry ewald contribution = 12.67074838 Ry convergence has been achieved in 6 iterations Writing output data file ch4-pr.save init_run : 0.53s CPU 0.56s WALL ( 1 calls) electrons : 9.09s CPU 9.27s WALL ( 1 calls) Called by init_run: wfcinit : 0.18s CPU 0.18s WALL ( 1 calls) potinit : 0.16s CPU 0.17s WALL ( 1 calls) Called by electrons: c_bands : 5.92s CPU 5.99s WALL ( 6 calls) sum_band : 1.27s CPU 1.28s WALL ( 6 calls) v_of_rho : 0.74s CPU 0.76s WALL ( 7 calls) mix_rho : 0.50s CPU 0.52s WALL ( 6 calls) Called by c_bands: init_us_2 : 0.02s CPU 0.02s WALL ( 13 calls) regterg : 5.91s CPU 5.98s WALL ( 6 calls) Called by *egterg: h_psi : 5.51s CPU 5.57s WALL ( 41 calls) g_psi : 0.04s CPU 0.04s WALL ( 34 calls) rdiaghg : 0.02s CPU 0.02s WALL ( 40 calls) Called by h_psi: add_vuspsi : 0.01s CPU 0.01s WALL ( 41 calls) General routines calbec : 0.11s CPU 0.11s WALL ( 41 calls) fft : 1.16s CPU 1.18s WALL ( 27 calls) fftw : 5.25s CPU 5.31s WALL ( 234 calls) Parallel routines fft_scatter : 2.61s CPU 2.67s WALL ( 261 calls) PWSCF : 10.07s CPU 10.32s WALL This run was terminated on: 13: 6:30 12Jan2012 =------------------------------------------------------------------------------= JOB DONE. =------------------------------------------------------------------------------= TDDFPT/Examples/CH4-PR/CH4-PR.pw-in0000644000175000017500000000132412341371500014443 0ustar mbamba&control calculation = 'scf' title = 'TDDFPT CH4 Test for projection' restart_mode='from_scratch', pseudo_dir = '../pseudo', outdir='./out', prefix='ch4-pr' etot_conv_thr=1d-6 wf_collect=.true. disk_io='low' / &system ibrav = 1, celldm(1) = 30, nat = 5, ntyp = 2, ecutwfc = 25, nbnd = 8, / &electrons / &ions / ATOMIC_SPECIES C 1.0 C.pz-vbc.UPF H 1.0 H.pz-vbc.UPF ATOMIC_POSITIONS {Angstrom} C 0.000000000 0.000000000 0.000000000 H 0.642814093 0.642814093 0.642814093 H -0.642814093 -0.642814093 0.642814093 H 0.642814093 -0.642814093 -0.642814093 H -0.642814093 0.642814093 -0.642814093 K_POINTS {gamma} TDDFPT/Examples/CH4-PR/CH4-PR.tddfpt-ref0000644000175000017500000247244112341371500015466 0ustar mbamba Program TDDFPT v.4.99 starts on 12Jan2012 at 13: 6:31 This program is part of the open-source Quantum ESPRESSO suite for quantum simulation of materials; please cite "P. Giannozzi et al., J. Phys.:Condens. Matter 21 395502 (2009); URL http://www.quantum-espresso.org", in publications or presentations arising from this work. More details at http://www.quantum-espresso.org/quote.php Parallel version (MPI), running on 4 processors R & G space division: proc/pool = 4 ---------------------------------------- This is TDDFPT (Time Dependent Density Functional Perturbation Theory) Sub Version: 0.9 ---------------------------------------- Ultrasoft (Vanderbilt) Pseudopotentials Info: using nr1, nr2, nr3 values from input Info: using nr1s, nr2s, nr3s values from input IMPORTANT: XC functional enforced from input : Exchange-correlation = SLA PZ NOGX NOGC ( 1 1 0 0 0) EXX-fraction = 0.00 Any further DFT definition will be discarded Please, verify this is what you really want file H.pz-vbc.UPF: wavefunction(s) 1S renormalized Parallelization info -------------------- sticks: dense smooth PW G-vecs: dense smooth PW Min 1787 1787 445 113964 113964 14262 Max 1790 1790 450 113970 113970 14264 Sum 7153 7153 1789 455863 455863 57051 Tot 3577 3577 895 Subspace diagonalization in iterative solution of the eigenvalue problem: a serial algorithm will be used Lanczos linear response spectrum calculation Number of Lanczos iterations = 500 Warning: There are virtual states in the input file, trying to disregard in response calculation Gamma point algorithm lr_wfcinit_spectrum: finished lr_solve_e Norm of initial Lanczos vectors= 1.841649869134100 Starting Lanczos loop 1 Lanczos iteration: 1 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal alpha(00000001)=0.000000000000000E+00 beta (00000002)=0.171988503139295E+01 gamma(00000002)=0.171988503139295E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 2 z1= 1 0.124520334742597E+01 0.000000000000000E+00 z1= 2 0.317095473869808E-06 0.000000000000000E+00 z1= 3 0.663024993342767E-06 0.000000000000000E+00 alpha(00000002)=0.000000000000000E+00 beta (00000003)=0.476672689891552E+01 gamma(00000003)=0.476672689891552E+01 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 3 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000003)=0.000000000000000E+00 beta (00000004)=0.135455819031628E+02 gamma(00000004)=0.135455819031628E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 4 z1= 1 -.355940407651614E+00 0.000000000000000E+00 z1= 2 -.709929704697555E-07 0.000000000000000E+00 z1= 3 -.218015962744734E-06 0.000000000000000E+00 alpha(00000004)=0.000000000000000E+00 beta (00000005)=0.127184680928597E+02 gamma(00000005)=0.127184680928597E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 5 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000005)=0.000000000000000E+00 beta (00000006)=0.134778713661835E+02 gamma(00000006)=0.134778713661835E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 6 z1= 1 0.303456793894284E+00 0.000000000000000E+00 z1= 2 0.729994181687156E-07 0.000000000000000E+00 z1= 3 0.220826351416271E-06 0.000000000000000E+00 alpha(00000006)=0.000000000000000E+00 beta (00000007)=0.128879302219375E+02 gamma(00000007)=0.128879302219375E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 7 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000007)=0.000000000000000E+00 beta (00000008)=0.133738472947644E+02 gamma(00000008)=0.133738472947644E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 8 z1= 1 -.273899700042011E+00 0.000000000000000E+00 z1= 2 -.815998917591803E-07 0.000000000000000E+00 z1= 3 -.240121425991723E-06 0.000000000000000E+00 alpha(00000008)=0.000000000000000E+00 beta (00000009)=0.128588212197025E+02 gamma(00000009)=0.128588212197025E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 9 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000009)=0.000000000000000E+00 beta (00000010)=0.134143943584606E+02 gamma(00000010)=0.134143943584606E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 10 z1= 1 0.250161944170694E+00 0.000000000000000E+00 z1= 2 0.754143489895692E-07 0.000000000000000E+00 z1= 3 0.261006942501929E-06 0.000000000000000E+00 alpha(00000010)=0.000000000000000E+00 beta (00000011)=0.128242646105845E+02 gamma(00000011)=0.128242646105845E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 11 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000011)=0.000000000000000E+00 beta (00000012)=0.134762987496952E+02 gamma(00000012)=0.134762987496952E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 12 z1= 1 -.228558099805471E+00 0.000000000000000E+00 z1= 2 -.686414724877446E-07 0.000000000000000E+00 z1= 3 -.281781214916195E-06 0.000000000000000E+00 alpha(00000012)=0.000000000000000E+00 beta (00000013)=0.128064510567046E+02 gamma(00000013)=0.128064510567046E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 13 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000013)=0.000000000000000E+00 beta (00000014)=0.134982211612641E+02 gamma(00000014)=0.134982211612641E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 14 z1= 1 0.209175389896875E+00 0.000000000000000E+00 z1= 2 0.779110487293157E-07 0.000000000000000E+00 z1= 3 0.297441224358767E-06 0.000000000000000E+00 alpha(00000014)=0.000000000000000E+00 beta (00000015)=0.128005701597246E+02 gamma(00000015)=0.128005701597246E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 15 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000015)=0.000000000000000E+00 beta (00000016)=0.134714904807318E+02 gamma(00000016)=0.134714904807318E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 16 z1= 1 -.192296691151057E+00 0.000000000000000E+00 z1= 2 -.953196138929469E-07 0.000000000000000E+00 z1= 3 -.303704543073730E-06 0.000000000000000E+00 alpha(00000016)=0.000000000000000E+00 beta (00000017)=0.127887193302416E+02 gamma(00000017)=0.127887193302416E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 17 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000017)=0.000000000000000E+00 beta (00000018)=0.134266175648045E+02 gamma(00000018)=0.134266175648045E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 18 z1= 1 0.177688165637444E+00 0.000000000000000E+00 z1= 2 0.113911880913163E-06 0.000000000000000E+00 z1= 3 0.300714177139580E-06 0.000000000000000E+00 alpha(00000018)=0.000000000000000E+00 beta (00000019)=0.127825615153248E+02 gamma(00000019)=0.127825615153248E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 19 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000019)=0.000000000000000E+00 beta (00000020)=0.134080225014896E+02 gamma(00000020)=0.134080225014896E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 20 z1= 1 -.164706328023573E+00 0.000000000000000E+00 z1= 2 -.146703496893465E-06 0.000000000000000E+00 z1= 3 -.298789065428099E-06 0.000000000000000E+00 alpha(00000020)=0.000000000000000E+00 beta (00000021)=0.128007405891743E+02 gamma(00000021)=0.128007405891743E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 21 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000021)=0.000000000000000E+00 beta (00000022)=0.134207199429619E+02 gamma(00000022)=0.134207199429619E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 22 z1= 1 0.153072725164172E+00 0.000000000000000E+00 z1= 2 0.167000018543029E-06 0.000000000000000E+00 z1= 3 0.288819380002848E-06 0.000000000000000E+00 alpha(00000022)=0.000000000000000E+00 beta (00000023)=0.128225843350253E+02 gamma(00000023)=0.128225843350253E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 23 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000023)=0.000000000000000E+00 beta (00000024)=0.134332985047371E+02 gamma(00000024)=0.134332985047371E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 24 z1= 1 -.142653586426500E+00 0.000000000000000E+00 z1= 2 -.176769482250223E-06 0.000000000000000E+00 z1= 3 -.279483744428143E-06 0.000000000000000E+00 alpha(00000024)=0.000000000000000E+00 beta (00000025)=0.128311412750717E+02 gamma(00000025)=0.128311412750717E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 25 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000025)=0.000000000000000E+00 beta (00000026)=0.134383835925919E+02 gamma(00000026)=0.134383835925919E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 26 z1= 1 0.133198511431655E+00 0.000000000000000E+00 z1= 2 0.183945885238578E-06 0.000000000000000E+00 z1= 3 0.294017734448696E-06 0.000000000000000E+00 alpha(00000026)=0.000000000000000E+00 beta (00000027)=0.128182255125753E+02 gamma(00000027)=0.128182255125753E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 27 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000027)=0.000000000000000E+00 beta (00000028)=0.134102256464240E+02 gamma(00000028)=0.134102256464240E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 28 z1= 1 -.124698046392641E+00 0.000000000000000E+00 z1= 2 -.178587660683120E-06 0.000000000000000E+00 z1= 3 -.320817650230451E-06 0.000000000000000E+00 alpha(00000028)=0.000000000000000E+00 beta (00000029)=0.127846778652988E+02 gamma(00000029)=0.127846778652988E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 29 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000029)=0.000000000000000E+00 beta (00000030)=0.134134228273156E+02 gamma(00000030)=0.134134228273156E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 30 z1= 1 0.116544736685154E+00 0.000000000000000E+00 z1= 2 0.165167278937117E-06 0.000000000000000E+00 z1= 3 0.338408872945384E-06 0.000000000000000E+00 alpha(00000030)=0.000000000000000E+00 beta (00000031)=0.128191527329623E+02 gamma(00000031)=0.128191527329623E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 31 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000031)=0.000000000000000E+00 beta (00000032)=0.134294009228354E+02 gamma(00000032)=0.134294009228354E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 32 z1= 1 -.109214203792739E+00 0.000000000000000E+00 z1= 2 -.148961257963581E-06 0.000000000000000E+00 z1= 3 -.341636058890564E-06 0.000000000000000E+00 alpha(00000032)=0.000000000000000E+00 beta (00000033)=0.127671183314944E+02 gamma(00000033)=0.127671183314944E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 33 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000033)=0.000000000000000E+00 beta (00000034)=0.133586624070168E+02 gamma(00000034)=0.133586624070168E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 34 z1= 1 0.102543468595489E+00 0.000000000000000E+00 z1= 2 0.126861167013166E-06 0.000000000000000E+00 z1= 3 0.350387747672981E-06 0.000000000000000E+00 alpha(00000034)=0.000000000000000E+00 beta (00000035)=0.127703274763539E+02 gamma(00000035)=0.127703274763539E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 35 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000035)=0.000000000000000E+00 beta (00000036)=0.134311106659527E+02 gamma(00000036)=0.134311106659527E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 36 z1= 1 -.958466447694731E-01 0.000000000000000E+00 z1= 2 -.104730672858926E-06 0.000000000000000E+00 z1= 3 -.356673057850415E-06 0.000000000000000E+00 alpha(00000036)=0.000000000000000E+00 beta (00000037)=0.128060606184881E+02 gamma(00000037)=0.128060606184881E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 37 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000037)=0.000000000000000E+00 beta (00000038)=0.133888972899599E+02 gamma(00000038)=0.133888972899599E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 38 z1= 1 0.901622998431228E-01 0.000000000000000E+00 z1= 2 0.872973411648881E-07 0.000000000000000E+00 z1= 3 0.361186554502253E-06 0.000000000000000E+00 alpha(00000038)=0.000000000000000E+00 beta (00000039)=0.127549634132078E+02 gamma(00000039)=0.127549634132078E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 39 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000039)=0.000000000000000E+00 beta (00000040)=0.133497045369355E+02 gamma(00000040)=0.133497045369355E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 40 z1= 1 -.847497650868138E-01 0.000000000000000E+00 z1= 2 -.698850330530312E-07 0.000000000000000E+00 z1= 3 -.360351918143311E-06 0.000000000000000E+00 alpha(00000040)=0.000000000000000E+00 beta (00000041)=0.126995463382604E+02 gamma(00000041)=0.126995463382604E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 41 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000041)=0.000000000000000E+00 beta (00000042)=0.133246757767513E+02 gamma(00000042)=0.133246757767513E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 42 z1= 1 0.794592930098019E-01 0.000000000000000E+00 z1= 2 0.498799826650909E-07 0.000000000000000E+00 z1= 3 0.353790508667994E-06 0.000000000000000E+00 alpha(00000042)=0.000000000000000E+00 beta (00000043)=0.127528421613253E+02 gamma(00000043)=0.127528421613253E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 43 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000043)=0.000000000000000E+00 beta (00000044)=0.133691963700601E+02 gamma(00000044)=0.133691963700601E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 44 z1= 1 -.746049876802575E-01 0.000000000000000E+00 z1= 2 -.292785169962728E-07 0.000000000000000E+00 z1= 3 -.361153975821072E-06 0.000000000000000E+00 alpha(00000044)=0.000000000000000E+00 beta (00000045)=0.127653035729734E+02 gamma(00000045)=0.127653035729734E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 45 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000045)=0.000000000000000E+00 beta (00000046)=0.134072306591372E+02 gamma(00000046)=0.134072306591372E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 46 z1= 1 0.699088962063403E-01 0.000000000000000E+00 z1= 2 0.171631698367425E-07 0.000000000000000E+00 z1= 3 0.365421957649052E-06 0.000000000000000E+00 alpha(00000046)=0.000000000000000E+00 beta (00000047)=0.127671150895094E+02 gamma(00000047)=0.127671150895094E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 47 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000047)=0.000000000000000E+00 beta (00000048)=0.133557571069238E+02 gamma(00000048)=0.133557571069238E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 48 z1= 1 -.657697202050140E-01 0.000000000000000E+00 z1= 2 -.169263177519224E-07 0.000000000000000E+00 z1= 3 -.360485822769306E-06 0.000000000000000E+00 alpha(00000048)=0.000000000000000E+00 beta (00000049)=0.128436214001654E+02 gamma(00000049)=0.128436214001654E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 49 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000049)=0.000000000000000E+00 beta (00000050)=0.134358308295089E+02 gamma(00000050)=0.134358308295089E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 50 z1= 1 0.619290029441438E-01 0.000000000000000E+00 z1= 2 0.248484081167080E-07 0.000000000000000E+00 z1= 3 0.362231282321807E-06 0.000000000000000E+00 alpha(00000050)=0.000000000000000E+00 beta (00000051)=0.126967568416403E+02 gamma(00000051)=0.126967568416403E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 51 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000051)=0.000000000000000E+00 beta (00000052)=0.132891123293467E+02 gamma(00000052)=0.132891123293467E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 52 z1= 1 -.582333860549248E-01 0.000000000000000E+00 z1= 2 -.378424913974329E-07 0.000000000000000E+00 z1= 3 -.376054178413991E-06 0.000000000000000E+00 alpha(00000052)=0.000000000000000E+00 beta (00000053)=0.127443370501644E+02 gamma(00000053)=0.127443370501644E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 53 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000053)=0.000000000000000E+00 beta (00000054)=0.133131464409104E+02 gamma(00000054)=0.133131464409104E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 54 z1= 1 0.549111851559616E-01 0.000000000000000E+00 z1= 2 0.461414481267228E-07 0.000000000000000E+00 z1= 3 0.386736516825616E-06 0.000000000000000E+00 alpha(00000054)=0.000000000000000E+00 beta (00000055)=0.127443546610177E+02 gamma(00000055)=0.127443546610177E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 55 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000055)=0.000000000000000E+00 beta (00000056)=0.133785355807721E+02 gamma(00000056)=0.133785355807721E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 56 z1= 1 -.515459520943306E-01 0.000000000000000E+00 z1= 2 -.679827492494622E-07 0.000000000000000E+00 z1= 3 -.386984238694892E-06 0.000000000000000E+00 alpha(00000056)=0.000000000000000E+00 beta (00000057)=0.128320509799064E+02 gamma(00000057)=0.128320509799064E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 57 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000057)=0.000000000000000E+00 beta (00000058)=0.134459854309694E+02 gamma(00000058)=0.134459854309694E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 58 z1= 1 0.484730003324594E-01 0.000000000000000E+00 z1= 2 0.919850068614725E-07 0.000000000000000E+00 z1= 3 0.390154895056160E-06 0.000000000000000E+00 alpha(00000058)=0.000000000000000E+00 beta (00000059)=0.127464084135541E+02 gamma(00000059)=0.127464084135541E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 59 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000059)=0.000000000000000E+00 beta (00000060)=0.133328228271439E+02 gamma(00000060)=0.133328228271439E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 60 z1= 1 -.457059357858629E-01 0.000000000000000E+00 z1= 2 -.109054515946318E-06 0.000000000000000E+00 z1= 3 -.401171588826506E-06 0.000000000000000E+00 alpha(00000060)=0.000000000000000E+00 beta (00000061)=0.128405797787776E+02 gamma(00000061)=0.128405797787776E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 61 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000061)=0.000000000000000E+00 beta (00000062)=0.133760314900567E+02 gamma(00000062)=0.133760314900567E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 62 z1= 1 0.432735976409498E-01 0.000000000000000E+00 z1= 2 0.119604457324285E-06 0.000000000000000E+00 z1= 3 0.409826960902902E-06 0.000000000000000E+00 alpha(00000062)=0.000000000000000E+00 beta (00000063)=0.128441819570853E+02 gamma(00000063)=0.128441819570853E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 63 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000063)=0.000000000000000E+00 beta (00000064)=0.134459510950132E+02 gamma(00000064)=0.134459510950132E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 64 z1= 1 -.408083948244251E-01 0.000000000000000E+00 z1= 2 -.131299869132566E-06 0.000000000000000E+00 z1= 3 -.411239326868619E-06 0.000000000000000E+00 alpha(00000064)=0.000000000000000E+00 beta (00000065)=0.128237674446673E+02 gamma(00000065)=0.128237674446673E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 65 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000065)=0.000000000000000E+00 beta (00000066)=0.134804256863556E+02 gamma(00000066)=0.134804256863556E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 66 z1= 1 0.383599128533590E-01 0.000000000000000E+00 z1= 2 0.149659896592734E-06 0.000000000000000E+00 z1= 3 0.407150572080315E-06 0.000000000000000E+00 alpha(00000066)=0.000000000000000E+00 beta (00000067)=0.128621045629678E+02 gamma(00000067)=0.128621045629678E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 67 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000067)=0.000000000000000E+00 beta (00000068)=0.133881841148913E+02 gamma(00000068)=0.133881841148913E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 68 z1= 1 -.364110885210623E-01 0.000000000000000E+00 z1= 2 -.163525031293688E-06 0.000000000000000E+00 z1= 3 -.409185854252604E-06 0.000000000000000E+00 alpha(00000068)=0.000000000000000E+00 beta (00000069)=0.128152870789198E+02 gamma(00000069)=0.128152870789198E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 69 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000069)=0.000000000000000E+00 beta (00000070)=0.133445173694389E+02 gamma(00000070)=0.133445173694389E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 70 z1= 1 0.345808815868468E-01 0.000000000000000E+00 z1= 2 0.173594340459673E-06 0.000000000000000E+00 z1= 3 0.411957077036621E-06 0.000000000000000E+00 alpha(00000070)=0.000000000000000E+00 beta (00000071)=0.128069647934933E+02 gamma(00000071)=0.128069647934933E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 71 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000071)=0.000000000000000E+00 beta (00000072)=0.134042168562389E+02 gamma(00000072)=0.134042168562389E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 72 z1= 1 -.326965735084420E-01 0.000000000000000E+00 z1= 2 -.178560453403288E-06 0.000000000000000E+00 z1= 3 -.408650682143068E-06 0.000000000000000E+00 alpha(00000072)=0.000000000000000E+00 beta (00000073)=0.128627096044086E+02 gamma(00000073)=0.128627096044086E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 73 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000073)=0.000000000000000E+00 beta (00000074)=0.133230432815588E+02 gamma(00000074)=0.133230432815588E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 74 z1= 1 0.313034850138304E-01 0.000000000000000E+00 z1= 2 0.184907473136861E-06 0.000000000000000E+00 z1= 3 0.401747916617770E-06 0.000000000000000E+00 alpha(00000074)=0.000000000000000E+00 beta (00000075)=0.127141928431595E+02 gamma(00000075)=0.127141928431595E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 75 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000075)=0.000000000000000E+00 beta (00000076)=0.133868796839417E+02 gamma(00000076)=0.133868796839417E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 76 z1= 1 -.294635617187391E-01 0.000000000000000E+00 z1= 2 -.193991977012579E-06 0.000000000000000E+00 z1= 3 -.388508151522092E-06 0.000000000000000E+00 alpha(00000076)=0.000000000000000E+00 beta (00000077)=0.127641760123857E+02 gamma(00000077)=0.127641760123857E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 77 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000077)=0.000000000000000E+00 beta (00000078)=0.133755104004219E+02 gamma(00000078)=0.133755104004219E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 78 z1= 1 0.278745168460386E-01 0.000000000000000E+00 z1= 2 0.212422699508944E-06 0.000000000000000E+00 z1= 3 0.375631066757711E-06 0.000000000000000E+00 alpha(00000078)=0.000000000000000E+00 beta (00000079)=0.128262857218772E+02 gamma(00000079)=0.128262857218772E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 79 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000079)=0.000000000000000E+00 beta (00000080)=0.133316289379736E+02 gamma(00000080)=0.133316289379736E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 80 z1= 1 -.266559155780984E-01 0.000000000000000E+00 z1= 2 -.238117507457385E-06 0.000000000000000E+00 z1= 3 -.369276508401200E-06 0.000000000000000E+00 alpha(00000080)=0.000000000000000E+00 beta (00000081)=0.127857332877510E+02 gamma(00000081)=0.127857332877510E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 81 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000081)=0.000000000000000E+00 beta (00000082)=0.133994473968668E+02 gamma(00000082)=0.133994473968668E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 82 z1= 1 0.253064284142861E-01 0.000000000000000E+00 z1= 2 0.261380404619795E-06 0.000000000000000E+00 z1= 3 0.371455303559815E-06 0.000000000000000E+00 alpha(00000082)=0.000000000000000E+00 beta (00000083)=0.128397009602121E+02 gamma(00000083)=0.128397009602121E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 83 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000083)=0.000000000000000E+00 beta (00000084)=0.133717645673665E+02 gamma(00000084)=0.133717645673665E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 84 z1= 1 -.241730284748381E-01 0.000000000000000E+00 z1= 2 -.299696386524880E-06 0.000000000000000E+00 z1= 3 -.374374016104580E-06 0.000000000000000E+00 alpha(00000084)=0.000000000000000E+00 beta (00000085)=0.128117725606991E+02 gamma(00000085)=0.128117725606991E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 85 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000085)=0.000000000000000E+00 beta (00000086)=0.133218180294894E+02 gamma(00000086)=0.133218180294894E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 86 z1= 1 0.231490293142133E-01 0.000000000000000E+00 z1= 2 0.339228402274766E-06 0.000000000000000E+00 z1= 3 0.372596752148350E-06 0.000000000000000E+00 alpha(00000086)=0.000000000000000E+00 beta (00000087)=0.127545881229632E+02 gamma(00000087)=0.127545881229632E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 87 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000087)=0.000000000000000E+00 beta (00000088)=0.133435623731637E+02 gamma(00000088)=0.133435623731637E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 88 z1= 1 -.220542256993823E-01 0.000000000000000E+00 z1= 2 -.372447332871485E-06 0.000000000000000E+00 z1= 3 -.376408738842534E-06 0.000000000000000E+00 alpha(00000088)=0.000000000000000E+00 beta (00000089)=0.128929978347644E+02 gamma(00000089)=0.128929978347644E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 89 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000089)=0.000000000000000E+00 beta (00000090)=0.133924342711202E+02 gamma(00000090)=0.133924342711202E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 90 z1= 1 0.211832396067604E-01 0.000000000000000E+00 z1= 2 0.407698566206628E-06 0.000000000000000E+00 z1= 3 0.379785358992687E-06 0.000000000000000E+00 alpha(00000090)=0.000000000000000E+00 beta (00000091)=0.126659751874259E+02 gamma(00000091)=0.126659751874259E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 91 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000091)=0.000000000000000E+00 beta (00000092)=0.133458506592244E+02 gamma(00000092)=0.133458506592244E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 92 z1= 1 -.200863094562753E-01 0.000000000000000E+00 z1= 2 -.422209001283216E-06 0.000000000000000E+00 z1= 3 -.379739547237473E-06 0.000000000000000E+00 alpha(00000092)=0.000000000000000E+00 beta (00000093)=0.127909396681337E+02 gamma(00000093)=0.127909396681337E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 93 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000093)=0.000000000000000E+00 beta (00000094)=0.133461370256088E+02 gamma(00000094)=0.133461370256088E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 94 z1= 1 0.192789146028386E-01 0.000000000000000E+00 z1= 2 0.451995666492667E-06 0.000000000000000E+00 z1= 3 0.381795591011726E-06 0.000000000000000E+00 alpha(00000094)=0.000000000000000E+00 beta (00000095)=0.127865790820774E+02 gamma(00000095)=0.127865790820774E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 95 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000095)=0.000000000000000E+00 beta (00000096)=0.133901013045594E+02 gamma(00000096)=0.133901013045594E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 96 z1= 1 -.184169131545688E-01 0.000000000000000E+00 z1= 2 -.478292122980690E-06 0.000000000000000E+00 z1= 3 -.382151120809874E-06 0.000000000000000E+00 alpha(00000096)=0.000000000000000E+00 beta (00000097)=0.127921043564931E+02 gamma(00000097)=0.127921043564931E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 97 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000097)=0.000000000000000E+00 beta (00000098)=0.134509416191960E+02 gamma(00000098)=0.134509416191960E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 98 z1= 1 0.175090571805012E-01 0.000000000000000E+00 z1= 2 0.494523929528640E-06 0.000000000000000E+00 z1= 3 0.373427974641042E-06 0.000000000000000E+00 alpha(00000098)=0.000000000000000E+00 beta (00000099)=0.130150727959673E+02 gamma(00000099)=0.130150727959673E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 99 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000099)=0.000000000000000E+00 beta (00000100)=0.136149108908864E+02 gamma(00000100)=0.136149108908864E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 100 z1= 1 -.167546599094435E-01 0.000000000000000E+00 z1= 2 -.515944896707730E-06 0.000000000000000E+00 z1= 3 -.363981079026690E-06 0.000000000000000E+00 alpha(00000100)=0.000000000000000E+00 beta (00000101)=0.127969559962275E+02 gamma(00000101)=0.127969559962275E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 101 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000101)=0.000000000000000E+00 beta (00000102)=0.132882480514421E+02 gamma(00000102)=0.132882480514421E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 102 z1= 1 0.161797853175664E-01 0.000000000000000E+00 z1= 2 0.541037899586417E-06 0.000000000000000E+00 z1= 3 0.353270947228576E-06 0.000000000000000E+00 alpha(00000102)=0.000000000000000E+00 beta (00000103)=0.128815690606503E+02 gamma(00000103)=0.128815690606503E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 103 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000103)=0.000000000000000E+00 beta (00000104)=0.134147767602552E+02 gamma(00000104)=0.134147767602552E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 104 z1= 1 -.156273509690295E-01 0.000000000000000E+00 z1= 2 -.562747698651216E-06 0.000000000000000E+00 z1= 3 -.336098349603341E-06 0.000000000000000E+00 alpha(00000104)=0.000000000000000E+00 beta (00000105)=0.128778633941098E+02 gamma(00000105)=0.128778633941098E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 105 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000105)=0.000000000000000E+00 beta (00000106)=0.132659013390477E+02 gamma(00000106)=0.132659013390477E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 106 z1= 1 0.152718966176220E-01 0.000000000000000E+00 z1= 2 0.593543796829302E-06 0.000000000000000E+00 z1= 3 0.327044875926921E-06 0.000000000000000E+00 alpha(00000106)=0.000000000000000E+00 beta (00000107)=0.126949465550008E+02 gamma(00000107)=0.126949465550008E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 107 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000107)=0.000000000000000E+00 beta (00000108)=0.133395812580347E+02 gamma(00000108)=0.133395812580347E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 108 z1= 1 -.145899325244997E-01 0.000000000000000E+00 z1= 2 -.620122297296860E-06 0.000000000000000E+00 z1= 3 -.308050886246007E-06 0.000000000000000E+00 alpha(00000108)=0.000000000000000E+00 beta (00000109)=0.128482756775422E+02 gamma(00000109)=0.128482756775422E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 109 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000109)=0.000000000000000E+00 beta (00000110)=0.133217660866958E+02 gamma(00000110)=0.133217660866958E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 110 z1= 1 0.141244534499666E-01 0.000000000000000E+00 z1= 2 0.654443013286101E-06 0.000000000000000E+00 z1= 3 0.283682922115136E-06 0.000000000000000E+00 alpha(00000110)=0.000000000000000E+00 beta (00000111)=0.126967122960627E+02 gamma(00000111)=0.126967122960627E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 111 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000111)=0.000000000000000E+00 beta (00000112)=0.135206893788410E+02 gamma(00000112)=0.135206893788410E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 112 z1= 1 -.133226919265497E-01 0.000000000000000E+00 z1= 2 -.682140455631397E-06 0.000000000000000E+00 z1= 3 -.256899064049357E-06 0.000000000000000E+00 alpha(00000112)=0.000000000000000E+00 beta (00000113)=0.129787488450375E+02 gamma(00000113)=0.129787488450375E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 113 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000113)=0.000000000000000E+00 beta (00000114)=0.134371970739290E+02 gamma(00000114)=0.134371970739290E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 114 z1= 1 0.129009766881108E-01 0.000000000000000E+00 z1= 2 0.730484093333129E-06 0.000000000000000E+00 z1= 3 0.244673875214249E-06 0.000000000000000E+00 alpha(00000114)=0.000000000000000E+00 beta (00000115)=0.127033501149243E+02 gamma(00000115)=0.127033501149243E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 115 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000115)=0.000000000000000E+00 beta (00000116)=0.135069835315474E+02 gamma(00000116)=0.135069835315474E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 116 z1= 1 -.122153982732531E-01 0.000000000000000E+00 z1= 2 -.761271567508446E-06 0.000000000000000E+00 z1= 3 -.219950388937341E-06 0.000000000000000E+00 alpha(00000116)=0.000000000000000E+00 beta (00000117)=0.127083381806927E+02 gamma(00000117)=0.127083381806927E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 117 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000117)=0.000000000000000E+00 beta (00000118)=0.132506528564081E+02 gamma(00000118)=0.132506528564081E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 118 z1= 1 0.118296558816171E-01 0.000000000000000E+00 z1= 2 0.814191366080991E-06 0.000000000000000E+00 z1= 3 0.200055966118680E-06 0.000000000000000E+00 alpha(00000118)=0.000000000000000E+00 beta (00000119)=0.127948306212576E+02 gamma(00000119)=0.127948306212576E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 119 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000119)=0.000000000000000E+00 beta (00000120)=0.133198404294845E+02 gamma(00000120)=0.133198404294845E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 120 z1= 1 -.114614482339868E-01 0.000000000000000E+00 z1= 2 -.855740453520239E-06 0.000000000000000E+00 z1= 3 -.179737052205726E-06 0.000000000000000E+00 alpha(00000120)=0.000000000000000E+00 beta (00000121)=0.125251007130107E+02 gamma(00000121)=0.125251007130107E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 121 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000121)=0.000000000000000E+00 beta (00000122)=0.131931003578598E+02 gamma(00000122)=0.131931003578598E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 122 z1= 1 0.109867078190985E-01 0.000000000000000E+00 z1= 2 0.883526422909304E-06 0.000000000000000E+00 z1= 3 0.157090489706364E-06 0.000000000000000E+00 alpha(00000122)=0.000000000000000E+00 beta (00000123)=0.127053182443001E+02 gamma(00000123)=0.127053182443001E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 123 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000123)=0.000000000000000E+00 beta (00000124)=0.133819590475111E+02 gamma(00000124)=0.133819590475111E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 124 z1= 1 -.105063040023175E-01 0.000000000000000E+00 z1= 2 -.911038637253694E-06 0.000000000000000E+00 z1= 3 -.145399384780137E-06 0.000000000000000E+00 alpha(00000124)=0.000000000000000E+00 beta (00000125)=0.126842069771290E+02 gamma(00000125)=0.126842069771290E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 125 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000125)=0.000000000000000E+00 beta (00000126)=0.133805656187695E+02 gamma(00000126)=0.133805656187695E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 126 z1= 1 0.100407198121749E-01 0.000000000000000E+00 z1= 2 0.935575094093959E-06 0.000000000000000E+00 z1= 3 0.130505171088650E-06 0.000000000000000E+00 alpha(00000126)=0.000000000000000E+00 beta (00000127)=0.128061217983270E+02 gamma(00000127)=0.128061217983270E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 127 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000127)=0.000000000000000E+00 beta (00000128)=0.132907873463496E+02 gamma(00000128)=0.132907873463496E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 128 z1= 1 -.973654736399135E-02 0.000000000000000E+00 z1= 2 -.975651045347255E-06 0.000000000000000E+00 z1= 3 -.109019815336284E-06 0.000000000000000E+00 alpha(00000128)=0.000000000000000E+00 beta (00000129)=0.127747979824044E+02 gamma(00000129)=0.127747979824044E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 129 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000129)=0.000000000000000E+00 beta (00000130)=0.132951221093815E+02 gamma(00000130)=0.132951221093815E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 130 z1= 1 0.941458437386726E-02 0.000000000000000E+00 z1= 2 0.100437098483723E-05 0.000000000000000E+00 z1= 3 0.921019464286059E-07 0.000000000000000E+00 alpha(00000130)=0.000000000000000E+00 beta (00000131)=0.127446368980114E+02 gamma(00000131)=0.127446368980114E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 131 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000131)=0.000000000000000E+00 beta (00000132)=0.131433389165322E+02 gamma(00000132)=0.131433389165322E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 132 z1= 1 -.917800668191584E-02 0.000000000000000E+00 z1= 2 -.103247825174874E-05 0.000000000000000E+00 z1= 3 -.716475946918539E-07 0.000000000000000E+00 alpha(00000132)=0.000000000000000E+00 beta (00000133)=0.127576275649699E+02 gamma(00000133)=0.127576275649699E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 133 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000133)=0.000000000000000E+00 beta (00000134)=0.134670373804933E+02 gamma(00000134)=0.134670373804933E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 134 z1= 1 0.869346845310137E-02 0.000000000000000E+00 z1= 2 0.102849041815935E-05 0.000000000000000E+00 z1= 3 0.501359931347504E-07 0.000000000000000E+00 alpha(00000134)=0.000000000000000E+00 beta (00000135)=0.127762111987481E+02 gamma(00000135)=0.127762111987481E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 135 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000135)=0.000000000000000E+00 beta (00000136)=0.134260196816553E+02 gamma(00000136)=0.134260196816553E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 136 z1= 1 -.830308344190589E-02 0.000000000000000E+00 z1= 2 -.102584942082967E-05 0.000000000000000E+00 z1= 3 -.283153749147756E-07 0.000000000000000E+00 alpha(00000136)=0.000000000000000E+00 beta (00000137)=0.129114181695599E+02 gamma(00000137)=0.129114181695599E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 137 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000137)=0.000000000000000E+00 beta (00000138)=0.133836378132805E+02 gamma(00000138)=0.133836378132805E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 138 z1= 1 0.809066839462529E-02 0.000000000000000E+00 z1= 2 0.103366758851236E-05 0.000000000000000E+00 z1= 3 0.214075210767310E-08 0.000000000000000E+00 alpha(00000138)=0.000000000000000E+00 beta (00000139)=0.129445301041632E+02 gamma(00000139)=0.129445301041632E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 139 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000139)=0.000000000000000E+00 beta (00000140)=0.135470945933053E+02 gamma(00000140)=0.135470945933053E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 140 z1= 1 -.782221861698094E-02 0.000000000000000E+00 z1= 2 -.103780122764560E-05 0.000000000000000E+00 z1= 3 0.153757342759601E-07 0.000000000000000E+00 alpha(00000140)=0.000000000000000E+00 beta (00000141)=0.127278500681737E+02 gamma(00000141)=0.127278500681737E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 141 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000141)=0.000000000000000E+00 beta (00000142)=0.134909225403750E+02 gamma(00000142)=0.134909225403750E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 142 z1= 1 0.747257450415641E-02 0.000000000000000E+00 z1= 2 0.103219084342894E-05 0.000000000000000E+00 z1= 3 -.426115503923685E-07 0.000000000000000E+00 alpha(00000142)=0.000000000000000E+00 beta (00000143)=0.127388156043148E+02 gamma(00000143)=0.127388156043148E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 143 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000143)=0.000000000000000E+00 beta (00000144)=0.134409861488023E+02 gamma(00000144)=0.134409861488023E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 144 z1= 1 -.714987006675110E-02 0.000000000000000E+00 z1= 2 -.103565575159965E-05 0.000000000000000E+00 z1= 3 0.747142200744396E-07 0.000000000000000E+00 alpha(00000144)=0.000000000000000E+00 beta (00000145)=0.129263380082070E+02 gamma(00000145)=0.129263380082070E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 145 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000145)=0.000000000000000E+00 beta (00000146)=0.133955227296483E+02 gamma(00000146)=0.133955227296483E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 146 z1= 1 0.694930825541806E-02 0.000000000000000E+00 z1= 2 0.105951586620119E-05 0.000000000000000E+00 z1= 3 -.106382370202709E-06 0.000000000000000E+00 alpha(00000146)=0.000000000000000E+00 beta (00000147)=0.128294771867733E+02 gamma(00000147)=0.128294771867733E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 147 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000147)=0.000000000000000E+00 beta (00000148)=0.136375187426128E+02 gamma(00000148)=0.136375187426128E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 148 z1= 1 -.656968419148941E-02 0.000000000000000E+00 z1= 2 -.105905023126737E-05 0.000000000000000E+00 z1= 3 0.143453457142687E-06 0.000000000000000E+00 alpha(00000148)=0.000000000000000E+00 beta (00000149)=0.127203052168230E+02 gamma(00000149)=0.127203052168230E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 149 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000149)=0.000000000000000E+00 beta (00000150)=0.135407487783685E+02 gamma(00000150)=0.135407487783685E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 150 z1= 1 0.618142103555483E-02 0.000000000000000E+00 z1= 2 0.106239929381548E-05 0.000000000000000E+00 z1= 3 -.176432842718000E-06 0.000000000000000E+00 alpha(00000150)=0.000000000000000E+00 beta (00000151)=0.126679065104762E+02 gamma(00000151)=0.126679065104762E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 151 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000151)=0.000000000000000E+00 beta (00000152)=0.134957587978244E+02 gamma(00000152)=0.134957587978244E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 152 z1= 1 -.579872160442296E-02 0.000000000000000E+00 z1= 2 -.105917501270472E-05 0.000000000000000E+00 z1= 3 0.207604477457245E-06 0.000000000000000E+00 alpha(00000152)=0.000000000000000E+00 beta (00000153)=0.125471928444096E+02 gamma(00000153)=0.125471928444096E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 153 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000153)=0.000000000000000E+00 beta (00000154)=0.132884914183278E+02 gamma(00000154)=0.132884914183278E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 154 z1= 1 0.545208339904904E-02 0.000000000000000E+00 z1= 2 0.105819184725723E-05 0.000000000000000E+00 z1= 3 -.241470418045934E-06 0.000000000000000E+00 alpha(00000154)=0.000000000000000E+00 beta (00000155)=0.128413090273545E+02 gamma(00000155)=0.128413090273545E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 155 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000155)=0.000000000000000E+00 beta (00000156)=0.133879531090786E+02 gamma(00000156)=0.133879531090786E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 156 z1= 1 -.518970398994723E-02 0.000000000000000E+00 z1= 2 -.107590853699359E-05 0.000000000000000E+00 z1= 3 0.269791300672021E-06 0.000000000000000E+00 alpha(00000156)=0.000000000000000E+00 beta (00000157)=0.128086763473672E+02 gamma(00000157)=0.128086763473672E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 157 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000157)=0.000000000000000E+00 beta (00000158)=0.135343392043371E+02 gamma(00000158)=0.135343392043371E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 158 z1= 1 0.482101765308390E-02 0.000000000000000E+00 z1= 2 0.107946488651163E-05 0.000000000000000E+00 z1= 3 -.298248007092757E-06 0.000000000000000E+00 alpha(00000158)=0.000000000000000E+00 beta (00000159)=0.127047571216248E+02 gamma(00000159)=0.127047571216248E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 159 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000159)=0.000000000000000E+00 beta (00000160)=0.132659520731535E+02 gamma(00000160)=0.132659520731535E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 160 z1= 1 -.451833137400098E-02 0.000000000000000E+00 z1= 2 -.108928754226963E-05 0.000000000000000E+00 z1= 3 0.326014265772411E-06 0.000000000000000E+00 alpha(00000160)=0.000000000000000E+00 beta (00000161)=0.125635444847843E+02 gamma(00000161)=0.125635444847843E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 161 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000161)=0.000000000000000E+00 beta (00000162)=0.133039650048178E+02 gamma(00000162)=0.133039650048178E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 162 z1= 1 0.422989393475103E-02 0.000000000000000E+00 z1= 2 0.107237096824784E-05 0.000000000000000E+00 z1= 3 -.341090419795948E-06 0.000000000000000E+00 alpha(00000162)=0.000000000000000E+00 beta (00000163)=0.127494976945611E+02 gamma(00000163)=0.127494976945611E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 163 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000163)=0.000000000000000E+00 beta (00000164)=0.131751220732392E+02 gamma(00000164)=0.131751220732392E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 164 z1= 1 -.411021181557778E-02 0.000000000000000E+00 z1= 2 -.107932415821434E-05 0.000000000000000E+00 z1= 3 0.358723656630386E-06 0.000000000000000E+00 alpha(00000164)=0.000000000000000E+00 beta (00000165)=0.126038858528184E+02 gamma(00000165)=0.126038858528184E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 165 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000165)=0.000000000000000E+00 beta (00000166)=0.134358651607230E+02 gamma(00000166)=0.134358651607230E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 166 z1= 1 0.389743633616330E-02 0.000000000000000E+00 z1= 2 0.106351651334526E-05 0.000000000000000E+00 z1= 3 -.363840099681196E-06 0.000000000000000E+00 alpha(00000166)=0.000000000000000E+00 beta (00000167)=0.127184531182956E+02 gamma(00000167)=0.127184531182956E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 167 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000167)=0.000000000000000E+00 beta (00000168)=0.134466491370528E+02 gamma(00000168)=0.134466491370528E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 168 z1= 1 -.379394926791080E-02 0.000000000000000E+00 z1= 2 -.106860606759532E-05 0.000000000000000E+00 z1= 3 0.375198667663533E-06 0.000000000000000E+00 alpha(00000168)=0.000000000000000E+00 beta (00000169)=0.127723830797894E+02 gamma(00000169)=0.127723830797894E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 169 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000169)=0.000000000000000E+00 beta (00000170)=0.132923299457340E+02 gamma(00000170)=0.132923299457340E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 170 z1= 1 0.375431419177870E-02 0.000000000000000E+00 z1= 2 0.108192136032614E-05 0.000000000000000E+00 z1= 3 -.391418672889303E-06 0.000000000000000E+00 alpha(00000170)=0.000000000000000E+00 beta (00000171)=0.127568537653709E+02 gamma(00000171)=0.127568537653709E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 171 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000171)=0.000000000000000E+00 beta (00000172)=0.133681844730715E+02 gamma(00000172)=0.133681844730715E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 172 z1= 1 -.371251517757455E-02 0.000000000000000E+00 z1= 2 -.108819798577816E-05 0.000000000000000E+00 z1= 3 0.411347411132380E-06 0.000000000000000E+00 alpha(00000172)=0.000000000000000E+00 beta (00000173)=0.127960390998196E+02 gamma(00000173)=0.127960390998196E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 173 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000173)=0.000000000000000E+00 beta (00000174)=0.134741880298252E+02 gamma(00000174)=0.134741880298252E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 174 z1= 1 0.357091419553455E-02 0.000000000000000E+00 z1= 2 0.109239864556866E-05 0.000000000000000E+00 z1= 3 -.421277122127886E-06 0.000000000000000E+00 alpha(00000174)=0.000000000000000E+00 beta (00000175)=0.128361165145557E+02 gamma(00000175)=0.128361165145557E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 175 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000175)=0.000000000000000E+00 beta (00000176)=0.133955756800338E+02 gamma(00000176)=0.133955756800338E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 176 z1= 1 -.335490482848328E-02 0.000000000000000E+00 z1= 2 -.110311873687419E-05 0.000000000000000E+00 z1= 3 0.437563654393229E-06 0.000000000000000E+00 alpha(00000176)=0.000000000000000E+00 beta (00000177)=0.127371839828646E+02 gamma(00000177)=0.127371839828646E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 177 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000177)=0.000000000000000E+00 beta (00000178)=0.133609363693625E+02 gamma(00000178)=0.133609363693625E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 178 z1= 1 0.312197134721187E-02 0.000000000000000E+00 z1= 2 0.111885663447043E-05 0.000000000000000E+00 z1= 3 -.455377773094499E-06 0.000000000000000E+00 alpha(00000178)=0.000000000000000E+00 beta (00000179)=0.126228630753695E+02 gamma(00000179)=0.126228630753695E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 179 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000179)=0.000000000000000E+00 beta (00000180)=0.134189381208145E+02 gamma(00000180)=0.134189381208145E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 180 z1= 1 -.280502188068698E-02 0.000000000000000E+00 z1= 2 -.111731527885871E-05 0.000000000000000E+00 z1= 3 0.470827569548724E-06 0.000000000000000E+00 alpha(00000180)=0.000000000000000E+00 beta (00000181)=0.127642282345104E+02 gamma(00000181)=0.127642282345104E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 181 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000181)=0.000000000000000E+00 beta (00000182)=0.134409127238685E+02 gamma(00000182)=0.134409127238685E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 182 z1= 1 0.252767765172751E-02 0.000000000000000E+00 z1= 2 0.112233211982003E-05 0.000000000000000E+00 z1= 3 -.495709351968591E-06 0.000000000000000E+00 alpha(00000182)=0.000000000000000E+00 beta (00000183)=0.128179004212276E+02 gamma(00000183)=0.128179004212276E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 183 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000183)=0.000000000000000E+00 beta (00000184)=0.135090365151892E+02 gamma(00000184)=0.135090365151892E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 184 z1= 1 -.229155380707699E-02 0.000000000000000E+00 z1= 2 -.111688186402777E-05 0.000000000000000E+00 z1= 3 0.506289451474397E-06 0.000000000000000E+00 alpha(00000184)=0.000000000000000E+00 beta (00000185)=0.129152290750697E+02 gamma(00000185)=0.129152290750697E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 185 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000185)=0.000000000000000E+00 beta (00000186)=0.133109436733325E+02 gamma(00000186)=0.133109436733325E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 186 z1= 1 0.208356679327469E-02 0.000000000000000E+00 z1= 2 0.113063285546791E-05 0.000000000000000E+00 z1= 3 -.524520215690712E-06 0.000000000000000E+00 alpha(00000186)=0.000000000000000E+00 beta (00000187)=0.127266818667874E+02 gamma(00000187)=0.127266818667874E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 187 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000187)=0.000000000000000E+00 beta (00000188)=0.134537848794894E+02 gamma(00000188)=0.134537848794894E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 188 z1= 1 -.185792183623537E-02 0.000000000000000E+00 z1= 2 -.110250647209474E-05 0.000000000000000E+00 z1= 3 0.531931530495304E-06 0.000000000000000E+00 alpha(00000188)=0.000000000000000E+00 beta (00000189)=0.129513195527258E+02 gamma(00000189)=0.129513195527258E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 189 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000189)=0.000000000000000E+00 beta (00000190)=0.137067215286686E+02 gamma(00000190)=0.137067215286686E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 190 z1= 1 0.163467287576130E-02 0.000000000000000E+00 z1= 2 0.107499524158120E-05 0.000000000000000E+00 z1= 3 -.531449173196154E-06 0.000000000000000E+00 alpha(00000190)=0.000000000000000E+00 beta (00000191)=0.128651968884116E+02 gamma(00000191)=0.128651968884116E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 191 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000191)=0.000000000000000E+00 beta (00000192)=0.134373766820750E+02 gamma(00000192)=0.134373766820750E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 192 z1= 1 -.143882185332284E-02 0.000000000000000E+00 z1= 2 -.105886850888456E-05 0.000000000000000E+00 z1= 3 0.542010971587350E-06 0.000000000000000E+00 alpha(00000192)=0.000000000000000E+00 beta (00000193)=0.127839119588456E+02 gamma(00000193)=0.127839119588456E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 193 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000193)=0.000000000000000E+00 beta (00000194)=0.131981251531839E+02 gamma(00000194)=0.131981251531839E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 194 z1= 1 0.131545235360777E-02 0.000000000000000E+00 z1= 2 0.105305416555094E-05 0.000000000000000E+00 z1= 3 -.554355806928729E-06 0.000000000000000E+00 alpha(00000194)=0.000000000000000E+00 beta (00000195)=0.126839745775896E+02 gamma(00000195)=0.126839745775896E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 195 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000195)=0.000000000000000E+00 beta (00000196)=0.133139834830163E+02 gamma(00000196)=0.133139834830163E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 196 z1= 1 -.121591283901509E-02 0.000000000000000E+00 z1= 2 -.102930249793560E-05 0.000000000000000E+00 z1= 3 0.558466701815544E-06 0.000000000000000E+00 alpha(00000196)=0.000000000000000E+00 beta (00000197)=0.126079509475032E+02 gamma(00000197)=0.126079509475032E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 197 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000197)=0.000000000000000E+00 beta (00000198)=0.136343158091605E+02 gamma(00000198)=0.136343158091605E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 198 z1= 1 0.114353515645789E-02 0.000000000000000E+00 z1= 2 0.981641408036435E-06 0.000000000000000E+00 z1= 3 -.543802321765596E-06 0.000000000000000E+00 alpha(00000198)=0.000000000000000E+00 beta (00000199)=0.126706191309363E+02 gamma(00000199)=0.126706191309363E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 199 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000199)=0.000000000000000E+00 beta (00000200)=0.134978593621574E+02 gamma(00000200)=0.134978593621574E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 200 z1= 1 -.113911411985839E-02 0.000000000000000E+00 z1= 2 -.955346051703264E-06 0.000000000000000E+00 z1= 3 0.546105423315075E-06 0.000000000000000E+00 alpha(00000200)=0.000000000000000E+00 beta (00000201)=0.126143078226329E+02 gamma(00000201)=0.126143078226329E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 201 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000201)=0.000000000000000E+00 beta (00000202)=0.133826748513058E+02 gamma(00000202)=0.133826748513058E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 202 z1= 1 0.113984829697640E-02 0.000000000000000E+00 z1= 2 0.927114220534899E-06 0.000000000000000E+00 z1= 3 -.550789200271364E-06 0.000000000000000E+00 alpha(00000202)=0.000000000000000E+00 beta (00000203)=0.127737791908955E+02 gamma(00000203)=0.127737791908955E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 203 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000203)=0.000000000000000E+00 beta (00000204)=0.135575564890144E+02 gamma(00000204)=0.135575564890144E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 204 z1= 1 -.112061632640548E-02 0.000000000000000E+00 z1= 2 -.896360847984536E-06 0.000000000000000E+00 z1= 3 0.552426030503265E-06 0.000000000000000E+00 alpha(00000204)=0.000000000000000E+00 beta (00000205)=0.128450514362886E+02 gamma(00000205)=0.128450514362886E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 205 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000205)=0.000000000000000E+00 beta (00000206)=0.134791529765032E+02 gamma(00000206)=0.134791529765032E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 206 z1= 1 0.117517379904983E-02 0.000000000000000E+00 z1= 2 0.883319222565182E-06 0.000000000000000E+00 z1= 3 -.563918251377741E-06 0.000000000000000E+00 alpha(00000206)=0.000000000000000E+00 beta (00000207)=0.127620257968271E+02 gamma(00000207)=0.127620257968271E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 207 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000207)=0.000000000000000E+00 beta (00000208)=0.133839143377821E+02 gamma(00000208)=0.133839143377821E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 208 z1= 1 -.125141545621655E-02 0.000000000000000E+00 z1= 2 -.878531473391501E-06 0.000000000000000E+00 z1= 3 0.574961863397834E-06 0.000000000000000E+00 alpha(00000208)=0.000000000000000E+00 beta (00000209)=0.126288027754579E+02 gamma(00000209)=0.126288027754579E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 209 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000209)=0.000000000000000E+00 beta (00000210)=0.135242431178511E+02 gamma(00000210)=0.135242431178511E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 210 z1= 1 0.133343583494327E-02 0.000000000000000E+00 z1= 2 0.873678503602454E-06 0.000000000000000E+00 z1= 3 -.570953538855706E-06 0.000000000000000E+00 alpha(00000210)=0.000000000000000E+00 beta (00000211)=0.126503383251568E+02 gamma(00000211)=0.126503383251568E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 211 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000211)=0.000000000000000E+00 beta (00000212)=0.135864455717396E+02 gamma(00000212)=0.135864455717396E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 212 z1= 1 -.134116145421016E-02 0.000000000000000E+00 z1= 2 -.865496757003655E-06 0.000000000000000E+00 z1= 3 0.565657256031398E-06 0.000000000000000E+00 alpha(00000212)=0.000000000000000E+00 beta (00000213)=0.126859780805401E+02 gamma(00000213)=0.126859780805401E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 213 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000213)=0.000000000000000E+00 beta (00000214)=0.134727118487149E+02 gamma(00000214)=0.134727118487149E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 214 z1= 1 0.124204621259663E-02 0.000000000000000E+00 z1= 2 0.850026841560381E-06 0.000000000000000E+00 z1= 3 -.570084573563352E-06 0.000000000000000E+00 alpha(00000214)=0.000000000000000E+00 beta (00000215)=0.125567710475452E+02 gamma(00000215)=0.125567710475452E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 215 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000215)=0.000000000000000E+00 beta (00000216)=0.132488407992983E+02 gamma(00000216)=0.132488407992983E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 216 z1= 1 -.111926534567439E-02 0.000000000000000E+00 z1= 2 -.851692033702542E-06 0.000000000000000E+00 z1= 3 0.573702861172498E-06 0.000000000000000E+00 alpha(00000216)=0.000000000000000E+00 beta (00000217)=0.124624285870993E+02 gamma(00000217)=0.124624285870993E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 217 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000217)=0.000000000000000E+00 beta (00000218)=0.136513087249418E+02 gamma(00000218)=0.136513087249418E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 218 z1= 1 0.927133309596425E-03 0.000000000000000E+00 z1= 2 0.828441397940360E-06 0.000000000000000E+00 z1= 3 -.552086111015688E-06 0.000000000000000E+00 alpha(00000218)=0.000000000000000E+00 beta (00000219)=0.127274171756467E+02 gamma(00000219)=0.127274171756467E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 219 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000219)=0.000000000000000E+00 beta (00000220)=0.134287316112827E+02 gamma(00000220)=0.134287316112827E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 220 z1= 1 -.776937897958834E-03 0.000000000000000E+00 z1= 2 -.850435106803174E-06 0.000000000000000E+00 z1= 3 0.552314499213473E-06 0.000000000000000E+00 alpha(00000220)=0.000000000000000E+00 beta (00000221)=0.127703385230753E+02 gamma(00000221)=0.127703385230753E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 221 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000221)=0.000000000000000E+00 beta (00000222)=0.132933852392960E+02 gamma(00000222)=0.132933852392960E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 222 z1= 1 0.620793139703533E-03 0.000000000000000E+00 z1= 2 0.872603414170045E-06 0.000000000000000E+00 z1= 3 -.564776487906190E-06 0.000000000000000E+00 alpha(00000222)=0.000000000000000E+00 beta (00000223)=0.128282662010717E+02 gamma(00000223)=0.128282662010717E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 223 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000223)=0.000000000000000E+00 beta (00000224)=0.132058851683286E+02 gamma(00000224)=0.132058851683286E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 224 z1= 1 -.430502528952067E-03 0.000000000000000E+00 z1= 2 -.910033572316601E-06 0.000000000000000E+00 z1= 3 0.581363414216295E-06 0.000000000000000E+00 alpha(00000224)=0.000000000000000E+00 beta (00000225)=0.129770284465301E+02 gamma(00000225)=0.129770284465301E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 225 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000225)=0.000000000000000E+00 beta (00000226)=0.133541678455374E+02 gamma(00000226)=0.133541678455374E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 226 z1= 1 0.236359807282170E-03 0.000000000000000E+00 z1= 2 0.944396300966988E-06 0.000000000000000E+00 z1= 3 -.599137290043590E-06 0.000000000000000E+00 alpha(00000226)=0.000000000000000E+00 beta (00000227)=0.128225177301424E+02 gamma(00000227)=0.128225177301424E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 227 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000227)=0.000000000000000E+00 beta (00000228)=0.135109032782034E+02 gamma(00000228)=0.135109032782034E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 228 z1= 1 -.768143767972554E-04 0.000000000000000E+00 z1= 2 -.953992358885755E-06 0.000000000000000E+00 z1= 3 0.599081158057216E-06 0.000000000000000E+00 alpha(00000228)=0.000000000000000E+00 beta (00000229)=0.127024305611170E+02 gamma(00000229)=0.127024305611170E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 229 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000229)=0.000000000000000E+00 beta (00000230)=0.134491685566602E+02 gamma(00000230)=0.134491685566602E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 230 z1= 1 -.456238715347496E-04 0.000000000000000E+00 z1= 2 0.972373499379120E-06 0.000000000000000E+00 z1= 3 -.599324632430094E-06 0.000000000000000E+00 alpha(00000230)=0.000000000000000E+00 beta (00000231)=0.129123583256806E+02 gamma(00000231)=0.129123583256806E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 231 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000231)=0.000000000000000E+00 beta (00000232)=0.137268118423163E+02 gamma(00000232)=0.137268118423163E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 232 z1= 1 0.113549625719299E-03 0.000000000000000E+00 z1= 2 -.987279831889468E-06 0.000000000000000E+00 z1= 3 0.598239286623620E-06 0.000000000000000E+00 alpha(00000232)=0.000000000000000E+00 beta (00000233)=0.127781226981588E+02 gamma(00000233)=0.127781226981588E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 233 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000233)=0.000000000000000E+00 beta (00000234)=0.133503640232404E+02 gamma(00000234)=0.133503640232404E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 234 z1= 1 -.180167775299335E-03 0.000000000000000E+00 z1= 2 0.100947541557643E-05 0.000000000000000E+00 z1= 3 -.616492567146924E-06 0.000000000000000E+00 alpha(00000234)=0.000000000000000E+00 beta (00000235)=0.125912037225209E+02 gamma(00000235)=0.125912037225209E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 235 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000235)=0.000000000000000E+00 beta (00000236)=0.133931145870886E+02 gamma(00000236)=0.133931145870886E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 236 z1= 1 0.213843106794772E-03 0.000000000000000E+00 z1= 2 -.102198524602661E-05 0.000000000000000E+00 z1= 3 0.618473620253503E-06 0.000000000000000E+00 alpha(00000236)=0.000000000000000E+00 beta (00000237)=0.128915709648554E+02 gamma(00000237)=0.128915709648554E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 237 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000237)=0.000000000000000E+00 beta (00000238)=0.135197347771400E+02 gamma(00000238)=0.135197347771400E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 238 z1= 1 -.247563404130971E-03 0.000000000000000E+00 z1= 2 0.104532226517275E-05 0.000000000000000E+00 z1= 3 -.624751022326373E-06 0.000000000000000E+00 alpha(00000238)=0.000000000000000E+00 beta (00000239)=0.127636417953653E+02 gamma(00000239)=0.127636417953653E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 239 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000239)=0.000000000000000E+00 beta (00000240)=0.133597456736146E+02 gamma(00000240)=0.133597456736146E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 240 z1= 1 0.255364305983827E-03 0.000000000000000E+00 z1= 2 -.108161162759362E-05 0.000000000000000E+00 z1= 3 0.638990187844658E-06 0.000000000000000E+00 alpha(00000240)=0.000000000000000E+00 beta (00000241)=0.127491189689346E+02 gamma(00000241)=0.127491189689346E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 241 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000241)=0.000000000000000E+00 beta (00000242)=0.134029067770379E+02 gamma(00000242)=0.134029067770379E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 242 z1= 1 -.217590215512890E-03 0.000000000000000E+00 z1= 2 0.110526645249890E-05 0.000000000000000E+00 z1= 3 -.643587884528100E-06 0.000000000000000E+00 alpha(00000242)=0.000000000000000E+00 beta (00000243)=0.128892970215508E+02 gamma(00000243)=0.128892970215508E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 243 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000243)=0.000000000000000E+00 beta (00000244)=0.135139908791647E+02 gamma(00000244)=0.135139908791647E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 244 z1= 1 0.176715163058954E-03 0.000000000000000E+00 z1= 2 -.113487006900368E-05 0.000000000000000E+00 z1= 3 0.646963887364219E-06 0.000000000000000E+00 alpha(00000244)=0.000000000000000E+00 beta (00000245)=0.125465565044629E+02 gamma(00000245)=0.125465565044629E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 245 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000245)=0.000000000000000E+00 beta (00000246)=0.130511096565475E+02 gamma(00000246)=0.130511096565475E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 246 z1= 1 -.687562975012924E-04 0.000000000000000E+00 z1= 2 0.118720817330817E-05 0.000000000000000E+00 z1= 3 -.669074717059813E-06 0.000000000000000E+00 alpha(00000246)=0.000000000000000E+00 beta (00000247)=0.125672166216960E+02 gamma(00000247)=0.125672166216960E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 247 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000247)=0.000000000000000E+00 beta (00000248)=0.133322010065832E+02 gamma(00000248)=0.133322010065832E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 248 z1= 1 -.265855779817228E-04 0.000000000000000E+00 z1= 2 -.121479055689667E-05 0.000000000000000E+00 z1= 3 0.681585116935524E-06 0.000000000000000E+00 alpha(00000248)=0.000000000000000E+00 beta (00000249)=0.127880890405297E+02 gamma(00000249)=0.127880890405297E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 249 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000249)=0.000000000000000E+00 beta (00000250)=0.134565553007533E+02 gamma(00000250)=0.134565553007533E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 250 z1= 1 0.128714655375224E-03 0.000000000000000E+00 z1= 2 0.126106313341583E-05 0.000000000000000E+00 z1= 3 -.694971007484248E-06 0.000000000000000E+00 alpha(00000250)=0.000000000000000E+00 beta (00000251)=0.125503578341436E+02 gamma(00000251)=0.125503578341436E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 251 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000251)=0.000000000000000E+00 beta (00000252)=0.132840485165938E+02 gamma(00000252)=0.132840485165938E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 252 z1= 1 -.179183404497101E-03 0.000000000000000E+00 z1= 2 -.129198898079705E-05 0.000000000000000E+00 z1= 3 0.714225997706409E-06 0.000000000000000E+00 alpha(00000252)=0.000000000000000E+00 beta (00000253)=0.129336344933673E+02 gamma(00000253)=0.129336344933673E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 253 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000253)=0.000000000000000E+00 beta (00000254)=0.135149055562963E+02 gamma(00000254)=0.135149055562963E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 254 z1= 1 0.150891841739855E-03 0.000000000000000E+00 z1= 2 0.133249794851808E-05 0.000000000000000E+00 z1= 3 -.735237230809133E-06 0.000000000000000E+00 alpha(00000254)=0.000000000000000E+00 beta (00000255)=0.128019264727368E+02 gamma(00000255)=0.128019264727368E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 255 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000255)=0.000000000000000E+00 beta (00000256)=0.136716635613044E+02 gamma(00000256)=0.136716635613044E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 256 z1= 1 -.136961296730704E-03 0.000000000000000E+00 z1= 2 -.132756300001962E-05 0.000000000000000E+00 z1= 3 0.740095829824107E-06 0.000000000000000E+00 alpha(00000256)=0.000000000000000E+00 beta (00000257)=0.128300167466652E+02 gamma(00000257)=0.128300167466652E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 257 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000257)=0.000000000000000E+00 beta (00000258)=0.134221769871968E+02 gamma(00000258)=0.134221769871968E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 258 z1= 1 0.138208485808052E-03 0.000000000000000E+00 z1= 2 0.134505375033733E-05 0.000000000000000E+00 z1= 3 -.763117093451342E-06 0.000000000000000E+00 alpha(00000258)=0.000000000000000E+00 beta (00000259)=0.130324506658008E+02 gamma(00000259)=0.130324506658008E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 259 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000259)=0.000000000000000E+00 beta (00000260)=0.135340662295567E+02 gamma(00000260)=0.135340662295567E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 260 z1= 1 -.927788765640526E-04 0.000000000000000E+00 z1= 2 -.136540499718479E-05 0.000000000000000E+00 z1= 3 0.786495671597533E-06 0.000000000000000E+00 alpha(00000260)=0.000000000000000E+00 beta (00000261)=0.127717179711288E+02 gamma(00000261)=0.127717179711288E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 261 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000261)=0.000000000000000E+00 beta (00000262)=0.133221305937690E+02 gamma(00000262)=0.133221305937690E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 262 z1= 1 0.478723208799893E-04 0.000000000000000E+00 z1= 2 0.139451889845724E-05 0.000000000000000E+00 z1= 3 -.808548213449120E-06 0.000000000000000E+00 alpha(00000262)=0.000000000000000E+00 beta (00000263)=0.126369438532460E+02 gamma(00000263)=0.126369438532460E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 263 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000263)=0.000000000000000E+00 beta (00000264)=0.132587176270206E+02 gamma(00000264)=0.132587176270206E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 264 z1= 1 -.455658322307505E-05 0.000000000000000E+00 z1= 2 -.141371746315185E-05 0.000000000000000E+00 z1= 3 0.832726922536550E-06 0.000000000000000E+00 alpha(00000264)=0.000000000000000E+00 beta (00000265)=0.127327473213858E+02 gamma(00000265)=0.127327473213858E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 265 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000265)=0.000000000000000E+00 beta (00000266)=0.134480107619529E+02 gamma(00000266)=0.134480107619529E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 266 z1= 1 0.648813969970907E-05 0.000000000000000E+00 z1= 2 0.143362690442888E-05 0.000000000000000E+00 z1= 3 -.847669821928745E-06 0.000000000000000E+00 alpha(00000266)=0.000000000000000E+00 beta (00000267)=0.127991040505564E+02 gamma(00000267)=0.127991040505564E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 267 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000267)=0.000000000000000E+00 beta (00000268)=0.133509673966330E+02 gamma(00000268)=0.133509673966330E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 268 z1= 1 -.567376802994108E-04 0.000000000000000E+00 z1= 2 -.147476342111756E-05 0.000000000000000E+00 z1= 3 0.861288036506217E-06 0.000000000000000E+00 alpha(00000268)=0.000000000000000E+00 beta (00000269)=0.126159925429635E+02 gamma(00000269)=0.126159925429635E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 269 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000269)=0.000000000000000E+00 beta (00000270)=0.135207235004554E+02 gamma(00000270)=0.135207235004554E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 270 z1= 1 0.127137685652246E-03 0.000000000000000E+00 z1= 2 0.147446017463061E-05 0.000000000000000E+00 z1= 3 -.850926267151298E-06 0.000000000000000E+00 alpha(00000270)=0.000000000000000E+00 beta (00000271)=0.130324162067741E+02 gamma(00000271)=0.130324162067741E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 271 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000271)=0.000000000000000E+00 beta (00000272)=0.132956054952244E+02 gamma(00000272)=0.132956054952244E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 272 z1= 1 -.191729312312948E-03 0.000000000000000E+00 z1= 2 -.155405386660819E-05 0.000000000000000E+00 z1= 3 0.886776127557586E-06 0.000000000000000E+00 alpha(00000272)=0.000000000000000E+00 beta (00000273)=0.127269498904768E+02 gamma(00000273)=0.127269498904768E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 273 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000273)=0.000000000000000E+00 beta (00000274)=0.134985209742731E+02 gamma(00000274)=0.134985209742731E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 274 z1= 1 0.170331338007786E-03 0.000000000000000E+00 z1= 2 0.157806383036148E-05 0.000000000000000E+00 z1= 3 -.880252715059794E-06 0.000000000000000E+00 alpha(00000274)=0.000000000000000E+00 beta (00000275)=0.128622188610237E+02 gamma(00000275)=0.128622188610237E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 275 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000275)=0.000000000000000E+00 beta (00000276)=0.137440451936213E+02 gamma(00000276)=0.137440451936213E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 276 z1= 1 -.142750271903275E-03 0.000000000000000E+00 z1= 2 -.157821809977730E-05 0.000000000000000E+00 z1= 3 0.873149851241851E-06 0.000000000000000E+00 alpha(00000276)=0.000000000000000E+00 beta (00000277)=0.127464668374159E+02 gamma(00000277)=0.127464668374159E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 277 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000277)=0.000000000000000E+00 beta (00000278)=0.131863671382823E+02 gamma(00000278)=0.131863671382823E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 278 z1= 1 0.109572272947518E-03 0.000000000000000E+00 z1= 2 0.163461486807001E-05 0.000000000000000E+00 z1= 3 -.901660216060408E-06 0.000000000000000E+00 alpha(00000278)=0.000000000000000E+00 beta (00000279)=0.125348509742997E+02 gamma(00000279)=0.125348509742997E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 279 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000279)=0.000000000000000E+00 beta (00000280)=0.133613119487983E+02 gamma(00000280)=0.133613119487983E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 280 z1= 1 -.760002265133737E-04 0.000000000000000E+00 z1= 2 -.163669660678198E-05 0.000000000000000E+00 z1= 3 0.896005116320575E-06 0.000000000000000E+00 alpha(00000280)=0.000000000000000E+00 beta (00000281)=0.128734593266187E+02 gamma(00000281)=0.128734593266187E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 281 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000281)=0.000000000000000E+00 beta (00000282)=0.132961411401249E+02 gamma(00000282)=0.132961411401249E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 282 z1= 1 0.276527334064029E-04 0.000000000000000E+00 z1= 2 0.168078713190609E-05 0.000000000000000E+00 z1= 3 -.912525533278022E-06 0.000000000000000E+00 alpha(00000282)=0.000000000000000E+00 beta (00000283)=0.125942924204340E+02 gamma(00000283)=0.125942924204340E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 283 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000283)=0.000000000000000E+00 beta (00000284)=0.132143412538638E+02 gamma(00000284)=0.132143412538638E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 284 z1= 1 0.583239420644463E-04 0.000000000000000E+00 z1= 2 -.169448499549429E-05 0.000000000000000E+00 z1= 3 0.909737797680373E-06 0.000000000000000E+00 alpha(00000284)=0.000000000000000E+00 beta (00000285)=0.126628071631529E+02 gamma(00000285)=0.126628071631529E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 285 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000285)=0.000000000000000E+00 beta (00000286)=0.134122172404607E+02 gamma(00000286)=0.134122172404607E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 286 z1= 1 -.190932279733869E-03 0.000000000000000E+00 z1= 2 0.168270811709472E-05 0.000000000000000E+00 z1= 3 -.905919346849617E-06 0.000000000000000E+00 alpha(00000286)=0.000000000000000E+00 beta (00000287)=0.126239998823110E+02 gamma(00000287)=0.126239998823110E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 287 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000287)=0.000000000000000E+00 beta (00000288)=0.130876625119869E+02 gamma(00000288)=0.130876625119869E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 288 z1= 1 0.349693419300639E-03 0.000000000000000E+00 z1= 2 -.171015172586650E-05 0.000000000000000E+00 z1= 3 0.920518477500582E-06 0.000000000000000E+00 alpha(00000288)=0.000000000000000E+00 beta (00000289)=0.127646903035548E+02 gamma(00000289)=0.127646903035548E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 289 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000289)=0.000000000000000E+00 beta (00000290)=0.134266705456058E+02 gamma(00000290)=0.134266705456058E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 290 z1= 1 -.501231307185227E-03 0.000000000000000E+00 z1= 2 0.170229397171819E-05 0.000000000000000E+00 z1= 3 -.927082524705670E-06 0.000000000000000E+00 alpha(00000290)=0.000000000000000E+00 beta (00000291)=0.127607097628115E+02 gamma(00000291)=0.127607097628115E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 291 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000291)=0.000000000000000E+00 beta (00000292)=0.131977142963550E+02 gamma(00000292)=0.131977142963550E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 292 z1= 1 0.625364817681611E-03 0.000000000000000E+00 z1= 2 -.172943302225326E-05 0.000000000000000E+00 z1= 3 0.944091772866199E-06 0.000000000000000E+00 alpha(00000292)=0.000000000000000E+00 beta (00000293)=0.126412174553989E+02 gamma(00000293)=0.126412174553989E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 293 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000293)=0.000000000000000E+00 beta (00000294)=0.135269290528757E+02 gamma(00000294)=0.135269290528757E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 294 z1= 1 -.725894581670368E-03 0.000000000000000E+00 z1= 2 0.167999408139628E-05 0.000000000000000E+00 z1= 3 -.913283330750174E-06 0.000000000000000E+00 alpha(00000294)=0.000000000000000E+00 beta (00000295)=0.129785084256467E+02 gamma(00000295)=0.129785084256467E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 295 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000295)=0.000000000000000E+00 beta (00000296)=0.135622808660767E+02 gamma(00000296)=0.135622808660767E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 296 z1= 1 0.768668939927513E-03 0.000000000000000E+00 z1= 2 -.168504087478920E-05 0.000000000000000E+00 z1= 3 0.904610650385811E-06 0.000000000000000E+00 alpha(00000296)=0.000000000000000E+00 beta (00000297)=0.127907360467252E+02 gamma(00000297)=0.127907360467252E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 297 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000297)=0.000000000000000E+00 beta (00000298)=0.133436968774994E+02 gamma(00000298)=0.133436968774994E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 298 z1= 1 -.707517468788372E-03 0.000000000000000E+00 z1= 2 0.167961114446585E-05 0.000000000000000E+00 z1= 3 -.902354954200336E-06 0.000000000000000E+00 alpha(00000298)=0.000000000000000E+00 beta (00000299)=0.130107129409987E+02 gamma(00000299)=0.130107129409987E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 299 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000299)=0.000000000000000E+00 beta (00000300)=0.136889181088334E+02 gamma(00000300)=0.136889181088334E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 300 z1= 1 0.684628564601643E-03 0.000000000000000E+00 z1= 2 -.167450096307713E-05 0.000000000000000E+00 z1= 3 0.890878449962199E-06 0.000000000000000E+00 alpha(00000300)=0.000000000000000E+00 beta (00000301)=0.127325812475916E+02 gamma(00000301)=0.127325812475916E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 301 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000301)=0.000000000000000E+00 beta (00000302)=0.132014509478762E+02 gamma(00000302)=0.132014509478762E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 302 z1= 1 -.647264218641776E-03 0.000000000000000E+00 z1= 2 0.168245271964414E-05 0.000000000000000E+00 z1= 3 -.907227271594309E-06 0.000000000000000E+00 alpha(00000302)=0.000000000000000E+00 beta (00000303)=0.127870314741178E+02 gamma(00000303)=0.127870314741178E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 303 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000303)=0.000000000000000E+00 beta (00000304)=0.135647539958655E+02 gamma(00000304)=0.135647539958655E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 304 z1= 1 0.551174922374189E-03 0.000000000000000E+00 z1= 2 -.166716131768264E-05 0.000000000000000E+00 z1= 3 0.898177204541504E-06 0.000000000000000E+00 alpha(00000304)=0.000000000000000E+00 beta (00000305)=0.128308768304114E+02 gamma(00000305)=0.128308768304114E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 305 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000305)=0.000000000000000E+00 beta (00000306)=0.134495322428984E+02 gamma(00000306)=0.134495322428984E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 306 z1= 1 -.426471941304514E-03 0.000000000000000E+00 z1= 2 0.167530919078498E-05 0.000000000000000E+00 z1= 3 -.898344154649051E-06 0.000000000000000E+00 alpha(00000306)=0.000000000000000E+00 beta (00000307)=0.127987523275910E+02 gamma(00000307)=0.127987523275910E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 307 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000307)=0.000000000000000E+00 beta (00000308)=0.135696281772165E+02 gamma(00000308)=0.135696281772165E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 308 z1= 1 0.239679137762927E-03 0.000000000000000E+00 z1= 2 -.166928034521507E-05 0.000000000000000E+00 z1= 3 0.883921430587672E-06 0.000000000000000E+00 alpha(00000308)=0.000000000000000E+00 beta (00000309)=0.127885451319368E+02 gamma(00000309)=0.127885451319368E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 309 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000309)=0.000000000000000E+00 beta (00000310)=0.133077725039452E+02 gamma(00000310)=0.133077725039452E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 310 z1= 1 -.705333776744449E-04 0.000000000000000E+00 z1= 2 0.168442483215736E-05 0.000000000000000E+00 z1= 3 -.877754750090915E-06 0.000000000000000E+00 alpha(00000310)=0.000000000000000E+00 beta (00000311)=0.127286690674846E+02 gamma(00000311)=0.127286690674846E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 311 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000311)=0.000000000000000E+00 beta (00000312)=0.134430704842425E+02 gamma(00000312)=0.134430704842425E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 312 z1= 1 -.739457855190775E-04 0.000000000000000E+00 z1= 2 -.168671184035411E-05 0.000000000000000E+00 z1= 3 0.863265367378064E-06 0.000000000000000E+00 alpha(00000312)=0.000000000000000E+00 beta (00000313)=0.128578466093019E+02 gamma(00000313)=0.128578466093019E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 313 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000313)=0.000000000000000E+00 beta (00000314)=0.132261696234449E+02 gamma(00000314)=0.132261696234449E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 314 z1= 1 0.259106840937338E-03 0.000000000000000E+00 z1= 2 0.174612297445414E-05 0.000000000000000E+00 z1= 3 -.880522102286621E-06 0.000000000000000E+00 alpha(00000314)=0.000000000000000E+00 beta (00000315)=0.124474650226159E+02 gamma(00000315)=0.124474650226159E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 315 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000315)=0.000000000000000E+00 beta (00000316)=0.134572319185595E+02 gamma(00000316)=0.134572319185595E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 316 z1= 1 -.404013283161572E-03 0.000000000000000E+00 z1= 2 -.172059706885202E-05 0.000000000000000E+00 z1= 3 0.855679319318914E-06 0.000000000000000E+00 alpha(00000316)=0.000000000000000E+00 beta (00000317)=0.125627927332960E+02 gamma(00000317)=0.125627927332960E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 317 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000317)=0.000000000000000E+00 beta (00000318)=0.134454999929261E+02 gamma(00000318)=0.134454999929261E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 318 z1= 1 0.507457592957055E-03 0.000000000000000E+00 z1= 2 0.171095648101964E-05 0.000000000000000E+00 z1= 3 -.844837863351596E-06 0.000000000000000E+00 alpha(00000318)=0.000000000000000E+00 beta (00000319)=0.125691239725402E+02 gamma(00000319)=0.125691239725402E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 319 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000319)=0.000000000000000E+00 beta (00000320)=0.132683726820441E+02 gamma(00000320)=0.132683726820441E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 320 z1= 1 -.613713715599071E-03 0.000000000000000E+00 z1= 2 -.173509690408599E-05 0.000000000000000E+00 z1= 3 0.850311119251720E-06 0.000000000000000E+00 alpha(00000320)=0.000000000000000E+00 beta (00000321)=0.128768070499523E+02 gamma(00000321)=0.128768070499523E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 321 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000321)=0.000000000000000E+00 beta (00000322)=0.135396593777757E+02 gamma(00000322)=0.135396593777757E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 322 z1= 1 0.611543137083495E-03 0.000000000000000E+00 z1= 2 0.178307841021625E-05 0.000000000000000E+00 z1= 3 -.859418121421248E-06 0.000000000000000E+00 alpha(00000322)=0.000000000000000E+00 beta (00000323)=0.127480205076653E+02 gamma(00000323)=0.127480205076653E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 323 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000323)=0.000000000000000E+00 beta (00000324)=0.132686642269067E+02 gamma(00000324)=0.132686642269067E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 324 z1= 1 -.593314845552301E-03 0.000000000000000E+00 z1= 2 -.183057700232285E-05 0.000000000000000E+00 z1= 3 0.867850659601235E-06 0.000000000000000E+00 alpha(00000324)=0.000000000000000E+00 beta (00000325)=0.127942811383426E+02 gamma(00000325)=0.127942811383426E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 325 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000325)=0.000000000000000E+00 beta (00000326)=0.137027023470101E+02 gamma(00000326)=0.137027023470101E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 326 z1= 1 0.515212369671513E-03 0.000000000000000E+00 z1= 2 0.183480101835281E-05 0.000000000000000E+00 z1= 3 -.846344731333308E-06 0.000000000000000E+00 alpha(00000326)=0.000000000000000E+00 beta (00000327)=0.126562954374660E+02 gamma(00000327)=0.126562954374660E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 327 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000327)=0.000000000000000E+00 beta (00000328)=0.132710996838658E+02 gamma(00000328)=0.132710996838658E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 328 z1= 1 -.372274808167227E-03 0.000000000000000E+00 z1= 2 -.186608044493272E-05 0.000000000000000E+00 z1= 3 0.850178972784855E-06 0.000000000000000E+00 alpha(00000328)=0.000000000000000E+00 beta (00000329)=0.128093992635456E+02 gamma(00000329)=0.128093992635456E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 329 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000329)=0.000000000000000E+00 beta (00000330)=0.136222241652883E+02 gamma(00000330)=0.136222241652883E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 330 z1= 1 0.204264921806225E-03 0.000000000000000E+00 z1= 2 0.188766628584649E-05 0.000000000000000E+00 z1= 3 -.844127140023669E-06 0.000000000000000E+00 alpha(00000330)=0.000000000000000E+00 beta (00000331)=0.126670299839844E+02 gamma(00000331)=0.126670299839844E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 331 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000331)=0.000000000000000E+00 beta (00000332)=0.133665217959362E+02 gamma(00000332)=0.133665217959362E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 332 z1= 1 0.520216036462105E-05 0.000000000000000E+00 z1= 2 -.191074840630930E-05 0.000000000000000E+00 z1= 3 0.845879706850574E-06 0.000000000000000E+00 alpha(00000332)=0.000000000000000E+00 beta (00000333)=0.128362235644113E+02 gamma(00000333)=0.128362235644113E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 333 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000333)=0.000000000000000E+00 beta (00000334)=0.134610383860623E+02 gamma(00000334)=0.134610383860623E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 334 z1= 1 -.149650802662429E-03 0.000000000000000E+00 z1= 2 0.196738899235186E-05 0.000000000000000E+00 z1= 3 -.858442704595758E-06 0.000000000000000E+00 alpha(00000334)=0.000000000000000E+00 beta (00000335)=0.124678202754767E+02 gamma(00000335)=0.124678202754767E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 335 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000335)=0.000000000000000E+00 beta (00000336)=0.130935940616502E+02 gamma(00000336)=0.130935940616502E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 336 z1= 1 0.268216931856626E-03 0.000000000000000E+00 z1= 2 -.201212838823583E-05 0.000000000000000E+00 z1= 3 0.877588814945625E-06 0.000000000000000E+00 alpha(00000336)=0.000000000000000E+00 beta (00000337)=0.129076797325912E+02 gamma(00000337)=0.129076797325912E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 337 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000337)=0.000000000000000E+00 beta (00000338)=0.135012897044665E+02 gamma(00000338)=0.135012897044665E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 338 z1= 1 -.430209631911072E-03 0.000000000000000E+00 z1= 2 0.207654465792266E-05 0.000000000000000E+00 z1= 3 -.895674804104519E-06 0.000000000000000E+00 alpha(00000338)=0.000000000000000E+00 beta (00000339)=0.126384611130740E+02 gamma(00000339)=0.126384611130740E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 339 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000339)=0.000000000000000E+00 beta (00000340)=0.132422097886978E+02 gamma(00000340)=0.132422097886978E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 340 z1= 1 0.595729902942817E-03 0.000000000000000E+00 z1= 2 -.212817026103108E-05 0.000000000000000E+00 z1= 3 0.918078602631545E-06 0.000000000000000E+00 alpha(00000340)=0.000000000000000E+00 beta (00000341)=0.126707155267549E+02 gamma(00000341)=0.126707155267549E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 341 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000341)=0.000000000000000E+00 beta (00000342)=0.136753650270820E+02 gamma(00000342)=0.136753650270820E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 342 z1= 1 -.712211639774271E-03 0.000000000000000E+00 z1= 2 0.211863388211732E-05 0.000000000000000E+00 z1= 3 -.913338079441568E-06 0.000000000000000E+00 alpha(00000342)=0.000000000000000E+00 beta (00000343)=0.127943575652756E+02 gamma(00000343)=0.127943575652756E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 343 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000343)=0.000000000000000E+00 beta (00000344)=0.135431220570199E+02 gamma(00000344)=0.135431220570199E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 344 z1= 1 0.857869650971173E-03 0.000000000000000E+00 z1= 2 -.212353928338307E-05 0.000000000000000E+00 z1= 3 0.934068680687915E-06 0.000000000000000E+00 alpha(00000344)=0.000000000000000E+00 beta (00000345)=0.129527933240723E+02 gamma(00000345)=0.129527933240723E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 345 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000345)=0.000000000000000E+00 beta (00000346)=0.134551236265833E+02 gamma(00000346)=0.134551236265833E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 346 z1= 1 -.104506027257694E-02 0.000000000000000E+00 z1= 2 0.220131595046681E-05 0.000000000000000E+00 z1= 3 -.961738683013743E-06 0.000000000000000E+00 alpha(00000346)=0.000000000000000E+00 beta (00000347)=0.125651899825453E+02 gamma(00000347)=0.125651899825453E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 347 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000347)=0.000000000000000E+00 beta (00000348)=0.134783820689339E+02 gamma(00000348)=0.134783820689339E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 348 z1= 1 0.116939543831404E-02 0.000000000000000E+00 z1= 2 -.219128906567192E-05 0.000000000000000E+00 z1= 3 0.964487218542664E-06 0.000000000000000E+00 alpha(00000348)=0.000000000000000E+00 beta (00000349)=0.129739915427084E+02 gamma(00000349)=0.129739915427084E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 349 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000349)=0.000000000000000E+00 beta (00000350)=0.134297645172635E+02 gamma(00000350)=0.134297645172635E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 350 z1= 1 -.135344050491708E-02 0.000000000000000E+00 z1= 2 0.225620922337903E-05 0.000000000000000E+00 z1= 3 -.993135379438910E-06 0.000000000000000E+00 alpha(00000350)=0.000000000000000E+00 beta (00000351)=0.125508321934906E+02 gamma(00000351)=0.125508321934906E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 351 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000351)=0.000000000000000E+00 beta (00000352)=0.134338381526123E+02 gamma(00000352)=0.134338381526123E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 352 z1= 1 0.143549901670042E-02 0.000000000000000E+00 z1= 2 -.223606631252283E-05 0.000000000000000E+00 z1= 3 0.100483244686549E-05 0.000000000000000E+00 alpha(00000352)=0.000000000000000E+00 beta (00000353)=0.129530888503404E+02 gamma(00000353)=0.129530888503404E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 353 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000353)=0.000000000000000E+00 beta (00000354)=0.132873546681447E+02 gamma(00000354)=0.132873546681447E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 354 z1= 1 -.157560451699969E-02 0.000000000000000E+00 z1= 2 0.233852346108281E-05 0.000000000000000E+00 z1= 3 -.105125643002821E-05 0.000000000000000E+00 alpha(00000354)=0.000000000000000E+00 beta (00000355)=0.124749146209501E+02 gamma(00000355)=0.124749146209501E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 355 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000355)=0.000000000000000E+00 beta (00000356)=0.136129809099013E+02 gamma(00000356)=0.136129809099013E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 356 z1= 1 0.166791202542283E-02 0.000000000000000E+00 z1= 2 -.227875773599492E-05 0.000000000000000E+00 z1= 3 0.102586970335061E-05 0.000000000000000E+00 alpha(00000356)=0.000000000000000E+00 beta (00000357)=0.128740517007964E+02 gamma(00000357)=0.128740517007964E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 357 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000357)=0.000000000000000E+00 beta (00000358)=0.136854129722098E+02 gamma(00000358)=0.136854129722098E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 358 z1= 1 -.178715673182855E-02 0.000000000000000E+00 z1= 2 0.230669507012221E-05 0.000000000000000E+00 z1= 3 -.104555659559359E-05 0.000000000000000E+00 alpha(00000358)=0.000000000000000E+00 beta (00000359)=0.126594210883743E+02 gamma(00000359)=0.126594210883743E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 359 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000359)=0.000000000000000E+00 beta (00000360)=0.138515727051040E+02 gamma(00000360)=0.138515727051040E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 360 z1= 1 0.183603267132077E-02 0.000000000000000E+00 z1= 2 -.227569132071155E-05 0.000000000000000E+00 z1= 3 0.103527777123977E-05 0.000000000000000E+00 alpha(00000360)=0.000000000000000E+00 beta (00000361)=0.124128308764972E+02 gamma(00000361)=0.124128308764972E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 361 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000361)=0.000000000000000E+00 beta (00000362)=0.134328018602647E+02 gamma(00000362)=0.134328018602647E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 362 z1= 1 -.191581550953614E-02 0.000000000000000E+00 z1= 2 0.230707324347162E-05 0.000000000000000E+00 z1= 3 -.104547600964828E-05 0.000000000000000E+00 alpha(00000362)=0.000000000000000E+00 beta (00000363)=0.128797689027868E+02 gamma(00000363)=0.128797689027868E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 363 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000363)=0.000000000000000E+00 beta (00000364)=0.135103476712929E+02 gamma(00000364)=0.135103476712929E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 364 z1= 1 0.201942123581042E-02 0.000000000000000E+00 z1= 2 -.240656018803912E-05 0.000000000000000E+00 z1= 3 0.108763236745510E-05 0.000000000000000E+00 alpha(00000364)=0.000000000000000E+00 beta (00000365)=0.122994663697766E+02 gamma(00000365)=0.122994663697766E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 365 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000365)=0.000000000000000E+00 beta (00000366)=0.129062964166017E+02 gamma(00000366)=0.129062964166017E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 366 z1= 1 -.211650740536665E-02 0.000000000000000E+00 z1= 2 0.252452689484053E-05 0.000000000000000E+00 z1= 3 -.114127949265371E-05 0.000000000000000E+00 alpha(00000366)=0.000000000000000E+00 beta (00000367)=0.127034717271188E+02 gamma(00000367)=0.127034717271188E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 367 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000367)=0.000000000000000E+00 beta (00000368)=0.134767217559440E+02 gamma(00000368)=0.134767217559440E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 368 z1= 1 0.215017449581701E-02 0.000000000000000E+00 z1= 2 -.259678228810246E-05 0.000000000000000E+00 z1= 3 0.117142236059174E-05 0.000000000000000E+00 alpha(00000368)=0.000000000000000E+00 beta (00000369)=0.125626745846411E+02 gamma(00000369)=0.125626745846411E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 369 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000369)=0.000000000000000E+00 beta (00000370)=0.133693021903321E+02 gamma(00000370)=0.133693021903321E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 370 z1= 1 -.212542264123549E-02 0.000000000000000E+00 z1= 2 0.264599046325038E-05 0.000000000000000E+00 z1= 3 -.121023538968813E-05 0.000000000000000E+00 alpha(00000370)=0.000000000000000E+00 beta (00000371)=0.128827453195214E+02 gamma(00000371)=0.128827453195214E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 371 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000371)=0.000000000000000E+00 beta (00000372)=0.133106988649915E+02 gamma(00000372)=0.133106988649915E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 372 z1= 1 0.214724781364811E-02 0.000000000000000E+00 z1= 2 -.278182824089718E-05 0.000000000000000E+00 z1= 3 0.127225826570328E-05 0.000000000000000E+00 alpha(00000372)=0.000000000000000E+00 beta (00000373)=0.128999414938028E+02 gamma(00000373)=0.128999414938028E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 373 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000373)=0.000000000000000E+00 beta (00000374)=0.136448728621549E+02 gamma(00000374)=0.136448728621549E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 374 z1= 1 -.207159507621628E-02 0.000000000000000E+00 z1= 2 0.283230973369001E-05 0.000000000000000E+00 z1= 3 -.130814550814559E-05 0.000000000000000E+00 alpha(00000374)=0.000000000000000E+00 beta (00000375)=0.128456626971522E+02 gamma(00000375)=0.128456626971522E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 375 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000375)=0.000000000000000E+00 beta (00000376)=0.131827389552599E+02 gamma(00000376)=0.131827389552599E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 376 z1= 1 0.196865024943700E-02 0.000000000000000E+00 z1= 2 -.299477034615848E-05 0.000000000000000E+00 z1= 3 0.137676865270939E-05 0.000000000000000E+00 alpha(00000376)=0.000000000000000E+00 beta (00000377)=0.130315447151673E+02 gamma(00000377)=0.130315447151673E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 377 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000377)=0.000000000000000E+00 beta (00000378)=0.135748818097699E+02 gamma(00000378)=0.135748818097699E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 378 z1= 1 -.176140183845043E-02 0.000000000000000E+00 z1= 2 0.308434431514669E-05 0.000000000000000E+00 z1= 3 -.143849278344495E-05 0.000000000000000E+00 alpha(00000378)=0.000000000000000E+00 beta (00000379)=0.125824307978207E+02 gamma(00000379)=0.125824307978207E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 379 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000379)=0.000000000000000E+00 beta (00000380)=0.133817946372658E+02 gamma(00000380)=0.133817946372658E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 380 z1= 1 0.147099362125275E-02 0.000000000000000E+00 z1= 2 -.315388384145672E-05 0.000000000000000E+00 z1= 3 0.146328125509381E-05 0.000000000000000E+00 alpha(00000380)=0.000000000000000E+00 beta (00000381)=0.131035164394389E+02 gamma(00000381)=0.131035164394389E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 381 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000381)=0.000000000000000E+00 beta (00000382)=0.134408251144571E+02 gamma(00000382)=0.134408251144571E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 382 z1= 1 -.127884804987194E-02 0.000000000000000E+00 z1= 2 0.328099606428404E-05 0.000000000000000E+00 z1= 3 -.153020560332215E-05 0.000000000000000E+00 alpha(00000382)=0.000000000000000E+00 beta (00000383)=0.129349547448582E+02 gamma(00000383)=0.129349547448582E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 383 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000383)=0.000000000000000E+00 beta (00000384)=0.134943392845839E+02 gamma(00000384)=0.134943392845839E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 384 z1= 1 0.111254869272987E-02 0.000000000000000E+00 z1= 2 -.337802323723468E-05 0.000000000000000E+00 z1= 3 0.155372437106612E-05 0.000000000000000E+00 alpha(00000384)=0.000000000000000E+00 beta (00000385)=0.126532948766842E+02 gamma(00000385)=0.126532948766842E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 385 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000385)=0.000000000000000E+00 beta (00000386)=0.130168829791860E+02 gamma(00000386)=0.130168829791860E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 386 z1= 1 -.969093515808193E-03 0.000000000000000E+00 z1= 2 0.349366693629290E-05 0.000000000000000E+00 z1= 3 -.160211226617353E-05 0.000000000000000E+00 alpha(00000386)=0.000000000000000E+00 beta (00000387)=0.129062706303159E+02 gamma(00000387)=0.129062706303159E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 387 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000387)=0.000000000000000E+00 beta (00000388)=0.133571549003554E+02 gamma(00000388)=0.133571549003554E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 388 z1= 1 0.840276174369285E-03 0.000000000000000E+00 z1= 2 -.357727149194421E-05 0.000000000000000E+00 z1= 3 0.162749060299636E-05 0.000000000000000E+00 alpha(00000388)=0.000000000000000E+00 beta (00000389)=0.125858293138876E+02 gamma(00000389)=0.125858293138876E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 389 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000389)=0.000000000000000E+00 beta (00000390)=0.134760386903092E+02 gamma(00000390)=0.134760386903092E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 390 z1= 1 -.731788659172157E-03 0.000000000000000E+00 z1= 2 0.351956976749924E-05 0.000000000000000E+00 z1= 3 -.158862711949898E-05 0.000000000000000E+00 alpha(00000390)=0.000000000000000E+00 beta (00000391)=0.129061674007458E+02 gamma(00000391)=0.129061674007458E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 391 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000391)=0.000000000000000E+00 beta (00000392)=0.131950568497570E+02 gamma(00000392)=0.131950568497570E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 392 z1= 1 0.746036909228398E-03 0.000000000000000E+00 z1= 2 -.362883421400548E-05 0.000000000000000E+00 z1= 3 0.161863361191548E-05 0.000000000000000E+00 alpha(00000392)=0.000000000000000E+00 beta (00000393)=0.126542790396239E+02 gamma(00000393)=0.126542790396239E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 393 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000393)=0.000000000000000E+00 beta (00000394)=0.133841508143345E+02 gamma(00000394)=0.133841508143345E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 394 z1= 1 -.723099031477817E-03 0.000000000000000E+00 z1= 2 0.359631395692277E-05 0.000000000000000E+00 z1= 3 -.158805764730486E-05 0.000000000000000E+00 alpha(00000394)=0.000000000000000E+00 beta (00000395)=0.126876710057053E+02 gamma(00000395)=0.126876710057053E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 395 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000395)=0.000000000000000E+00 beta (00000396)=0.132038028396582E+02 gamma(00000396)=0.132038028396582E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 396 z1= 1 0.635033899586749E-03 0.000000000000000E+00 z1= 2 -.363862670948708E-05 0.000000000000000E+00 z1= 3 0.158564903764754E-05 0.000000000000000E+00 alpha(00000396)=0.000000000000000E+00 beta (00000397)=0.127102564059082E+02 gamma(00000397)=0.127102564059082E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 397 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000397)=0.000000000000000E+00 beta (00000398)=0.131579806495601E+02 gamma(00000398)=0.131579806495601E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 398 z1= 1 -.431202815231577E-03 0.000000000000000E+00 z1= 2 0.367843750192142E-05 0.000000000000000E+00 z1= 3 -.159063400498023E-05 0.000000000000000E+00 alpha(00000398)=0.000000000000000E+00 beta (00000399)=0.126877559231659E+02 gamma(00000399)=0.126877559231659E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 399 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000399)=0.000000000000000E+00 beta (00000400)=0.136083917669130E+02 gamma(00000400)=0.136083917669130E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 400 z1= 1 0.190075065094068E-03 0.000000000000000E+00 z1= 2 -.359823066047558E-05 0.000000000000000E+00 z1= 3 0.154609263904504E-05 0.000000000000000E+00 alpha(00000400)=0.000000000000000E+00 beta (00000401)=0.128719340976581E+02 gamma(00000401)=0.128719340976581E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 401 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000401)=0.000000000000000E+00 beta (00000402)=0.132282549626586E+02 gamma(00000402)=0.132282549626586E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 402 z1= 1 0.834522214406175E-04 0.000000000000000E+00 z1= 2 0.365877063925784E-05 0.000000000000000E+00 z1= 3 -.156010586265041E-05 0.000000000000000E+00 alpha(00000402)=0.000000000000000E+00 beta (00000403)=0.129674360628020E+02 gamma(00000403)=0.129674360628020E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 403 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000403)=0.000000000000000E+00 beta (00000404)=0.133464190932160E+02 gamma(00000404)=0.133464190932160E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 404 z1= 1 -.280664616802044E-03 0.000000000000000E+00 z1= 2 -.371387371356138E-05 0.000000000000000E+00 z1= 3 0.156715869557627E-05 0.000000000000000E+00 alpha(00000404)=0.000000000000000E+00 beta (00000405)=0.126603067878984E+02 gamma(00000405)=0.126603067878984E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 405 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000405)=0.000000000000000E+00 beta (00000406)=0.135477429842835E+02 gamma(00000406)=0.135477429842835E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 406 z1= 1 0.445851546046762E-03 0.000000000000000E+00 z1= 2 0.361801634227404E-05 0.000000000000000E+00 z1= 3 -.151489390767877E-05 0.000000000000000E+00 alpha(00000406)=0.000000000000000E+00 beta (00000407)=0.127114680078995E+02 gamma(00000407)=0.127114680078995E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 407 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000407)=0.000000000000000E+00 beta (00000408)=0.130764909171738E+02 gamma(00000408)=0.130764909171738E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 408 z1= 1 -.686866310734096E-03 0.000000000000000E+00 z1= 2 -.368943701609939E-05 0.000000000000000E+00 z1= 3 0.153817252869596E-05 0.000000000000000E+00 alpha(00000408)=0.000000000000000E+00 beta (00000409)=0.129445442339463E+02 gamma(00000409)=0.129445442339463E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 409 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000409)=0.000000000000000E+00 beta (00000410)=0.133572041136436E+02 gamma(00000410)=0.133572041136436E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 410 z1= 1 0.927455071898040E-03 0.000000000000000E+00 z1= 2 0.374702782119578E-05 0.000000000000000E+00 z1= 3 -.154843940180480E-05 0.000000000000000E+00 alpha(00000410)=0.000000000000000E+00 beta (00000411)=0.128095677899156E+02 gamma(00000411)=0.128095677899156E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 411 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000411)=0.000000000000000E+00 beta (00000412)=0.138140861407431E+02 gamma(00000412)=0.138140861407431E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 412 z1= 1 -.106199446160312E-02 0.000000000000000E+00 z1= 2 -.363388861376619E-05 0.000000000000000E+00 z1= 3 0.150529055998149E-05 0.000000000000000E+00 alpha(00000412)=0.000000000000000E+00 beta (00000413)=0.124499136145000E+02 gamma(00000413)=0.124499136145000E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 413 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000413)=0.000000000000000E+00 beta (00000414)=0.133787633226410E+02 gamma(00000414)=0.133787633226410E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 414 z1= 1 0.111323811915035E-02 0.000000000000000E+00 z1= 2 0.355690483681273E-05 0.000000000000000E+00 z1= 3 -.146614219978774E-05 0.000000000000000E+00 alpha(00000414)=0.000000000000000E+00 beta (00000415)=0.130605904309975E+02 gamma(00000415)=0.130605904309975E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 415 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000415)=0.000000000000000E+00 beta (00000416)=0.135228180034523E+02 gamma(00000416)=0.135228180034523E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 416 z1= 1 -.106535506769477E-02 0.000000000000000E+00 z1= 2 -.360894324256044E-05 0.000000000000000E+00 z1= 3 0.148757284969835E-05 0.000000000000000E+00 alpha(00000416)=0.000000000000000E+00 beta (00000417)=0.126275286424197E+02 gamma(00000417)=0.126275286424197E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 417 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000417)=0.000000000000000E+00 beta (00000418)=0.138147967798930E+02 gamma(00000418)=0.138147967798930E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 418 z1= 1 0.855623342311018E-03 0.000000000000000E+00 z1= 2 0.347840254424090E-05 0.000000000000000E+00 z1= 3 -.142186264193476E-05 0.000000000000000E+00 alpha(00000418)=0.000000000000000E+00 beta (00000419)=0.126621244888621E+02 gamma(00000419)=0.126621244888621E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 419 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000419)=0.000000000000000E+00 beta (00000420)=0.135334976896664E+02 gamma(00000420)=0.135334976896664E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 420 z1= 1 -.679883375782286E-03 0.000000000000000E+00 z1= 2 -.343535056970649E-05 0.000000000000000E+00 z1= 3 0.140527138238778E-05 0.000000000000000E+00 alpha(00000420)=0.000000000000000E+00 beta (00000421)=0.128427746894213E+02 gamma(00000421)=0.128427746894213E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 421 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000421)=0.000000000000000E+00 beta (00000422)=0.130972341905300E+02 gamma(00000422)=0.130972341905300E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 422 z1= 1 0.621546045991187E-03 0.000000000000000E+00 z1= 2 0.355050586750344E-05 0.000000000000000E+00 z1= 3 -.145380588207378E-05 0.000000000000000E+00 alpha(00000422)=0.000000000000000E+00 beta (00000423)=0.127561521678028E+02 gamma(00000423)=0.127561521678028E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 423 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000423)=0.000000000000000E+00 beta (00000424)=0.136009918701737E+02 gamma(00000424)=0.136009918701737E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 424 z1= 1 -.547658655345090E-03 0.000000000000000E+00 z1= 2 -.350312464365539E-05 0.000000000000000E+00 z1= 3 0.143489376920379E-05 0.000000000000000E+00 alpha(00000424)=0.000000000000000E+00 beta (00000425)=0.123518097895918E+02 gamma(00000425)=0.123518097895918E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 425 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000425)=0.000000000000000E+00 beta (00000426)=0.137429575264373E+02 gamma(00000426)=0.137429575264373E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 426 z1= 1 0.422046302059281E-03 0.000000000000000E+00 z1= 2 0.332413442111126E-05 0.000000000000000E+00 z1= 3 -.137278654819390E-05 0.000000000000000E+00 alpha(00000426)=0.000000000000000E+00 beta (00000427)=0.127408145603928E+02 gamma(00000427)=0.127408145603928E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 427 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000427)=0.000000000000000E+00 beta (00000428)=0.133045013934137E+02 gamma(00000428)=0.133045013934137E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 428 z1= 1 -.212886656578828E-03 0.000000000000000E+00 z1= 2 -.336399109907362E-05 0.000000000000000E+00 z1= 3 0.141780779951001E-05 0.000000000000000E+00 alpha(00000428)=0.000000000000000E+00 beta (00000429)=0.128353464594813E+02 gamma(00000429)=0.128353464594813E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 429 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000429)=0.000000000000000E+00 beta (00000430)=0.132090488525703E+02 gamma(00000430)=0.132090488525703E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 430 z1= 1 -.141134921126863E-03 0.000000000000000E+00 z1= 2 0.345564149121158E-05 0.000000000000000E+00 z1= 3 -.145981437012482E-05 0.000000000000000E+00 alpha(00000430)=0.000000000000000E+00 beta (00000431)=0.129472393630367E+02 gamma(00000431)=0.129472393630367E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 431 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000431)=0.000000000000000E+00 beta (00000432)=0.135190732045103E+02 gamma(00000432)=0.135190732045103E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 432 z1= 1 0.469648906546353E-03 0.000000000000000E+00 z1= 2 -.347195752868883E-05 0.000000000000000E+00 z1= 3 0.147050634908619E-05 0.000000000000000E+00 alpha(00000432)=0.000000000000000E+00 beta (00000433)=0.125895540199686E+02 gamma(00000433)=0.125895540199686E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 433 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000433)=0.000000000000000E+00 beta (00000434)=0.137837564661999E+02 gamma(00000434)=0.137837564661999E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 434 z1= 1 -.699355505337226E-03 0.000000000000000E+00 z1= 2 0.333704105134978E-05 0.000000000000000E+00 z1= 3 -.141463466799799E-05 0.000000000000000E+00 alpha(00000434)=0.000000000000000E+00 beta (00000435)=0.128837839046491E+02 gamma(00000435)=0.128837839046491E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 435 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000435)=0.000000000000000E+00 beta (00000436)=0.132266241766140E+02 gamma(00000436)=0.132266241766140E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 436 z1= 1 0.900406287770350E-03 0.000000000000000E+00 z1= 2 -.343402331154331E-05 0.000000000000000E+00 z1= 3 0.147271416023288E-05 0.000000000000000E+00 alpha(00000436)=0.000000000000000E+00 beta (00000437)=0.129067969303855E+02 gamma(00000437)=0.129067969303855E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 437 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000437)=0.000000000000000E+00 beta (00000438)=0.128547305937039E+02 gamma(00000438)=0.128547305937039E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 438 z1= 1 -.935412505457206E-03 0.000000000000000E+00 z1= 2 0.364537805887960E-05 0.000000000000000E+00 z1= 3 -.157846722737736E-05 0.000000000000000E+00 alpha(00000438)=0.000000000000000E+00 beta (00000439)=0.127824577418095E+02 gamma(00000439)=0.127824577418095E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 439 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000439)=0.000000000000000E+00 beta (00000440)=0.133184598040274E+02 gamma(00000440)=0.133184598040274E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 440 z1= 1 0.810557675769655E-03 0.000000000000000E+00 z1= 2 -.369890815444260E-05 0.000000000000000E+00 z1= 3 0.160453326996496E-05 0.000000000000000E+00 alpha(00000440)=0.000000000000000E+00 beta (00000441)=0.124654961302202E+02 gamma(00000441)=0.124654961302202E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 441 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000441)=0.000000000000000E+00 beta (00000442)=0.134802936431358E+02 gamma(00000442)=0.134802936431358E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 442 z1= 1 -.516499840829411E-03 0.000000000000000E+00 z1= 2 0.361668916411522E-05 0.000000000000000E+00 z1= 3 -.157822567910574E-05 0.000000000000000E+00 alpha(00000442)=0.000000000000000E+00 beta (00000443)=0.125905811277231E+02 gamma(00000443)=0.125905811277231E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 443 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000443)=0.000000000000000E+00 beta (00000444)=0.133373870821853E+02 gamma(00000444)=0.133373870821853E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 444 z1= 1 0.180584493924575E-03 0.000000000000000E+00 z1= 2 -.363002011056525E-05 0.000000000000000E+00 z1= 3 0.159138073648553E-05 0.000000000000000E+00 alpha(00000444)=0.000000000000000E+00 beta (00000445)=0.132098622582981E+02 gamma(00000445)=0.132098622582981E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 445 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000445)=0.000000000000000E+00 beta (00000446)=0.130285548453076E+02 gamma(00000446)=0.130285548453076E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 446 z1= 1 0.130021097275945E-03 0.000000000000000E+00 z1= 2 0.390303612414662E-05 0.000000000000000E+00 z1= 3 -.171093881599612E-05 0.000000000000000E+00 alpha(00000446)=0.000000000000000E+00 beta (00000447)=0.129522390838715E+02 gamma(00000447)=0.129522390838715E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 447 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000447)=0.000000000000000E+00 beta (00000448)=0.132092080495859E+02 gamma(00000448)=0.132092080495859E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 448 z1= 1 -.343919605104527E-03 0.000000000000000E+00 z1= 2 -.403725654792454E-05 0.000000000000000E+00 z1= 3 0.176583130495817E-05 0.000000000000000E+00 alpha(00000448)=0.000000000000000E+00 beta (00000449)=0.129489703402699E+02 gamma(00000449)=0.129489703402699E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 449 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000449)=0.000000000000000E+00 beta (00000450)=0.136503994660051E+02 gamma(00000450)=0.136503994660051E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 450 z1= 1 0.462366898619949E-03 0.000000000000000E+00 z1= 2 0.401715509397698E-05 0.000000000000000E+00 z1= 3 -.174798004568964E-05 0.000000000000000E+00 alpha(00000450)=0.000000000000000E+00 beta (00000451)=0.124501796398890E+02 gamma(00000451)=0.124501796398890E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 451 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000451)=0.000000000000000E+00 beta (00000452)=0.137434180887783E+02 gamma(00000452)=0.137434180887783E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 452 z1= 1 -.621808969288577E-03 0.000000000000000E+00 z1= 2 -.382856706656297E-05 0.000000000000000E+00 z1= 3 0.166193210556441E-05 0.000000000000000E+00 alpha(00000452)=0.000000000000000E+00 beta (00000453)=0.123493020496221E+02 gamma(00000453)=0.123493020496221E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 453 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000453)=0.000000000000000E+00 beta (00000454)=0.136342995678223E+02 gamma(00000454)=0.136342995678223E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 454 z1= 1 0.741023024345253E-03 0.000000000000000E+00 z1= 2 0.367567656215598E-05 0.000000000000000E+00 z1= 3 -.159860420652044E-05 0.000000000000000E+00 alpha(00000454)=0.000000000000000E+00 beta (00000455)=0.124949139211444E+02 gamma(00000455)=0.124949139211444E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 455 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000455)=0.000000000000000E+00 beta (00000456)=0.136130168730011E+02 gamma(00000456)=0.136130168730011E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 456 z1= 1 -.936953181289920E-03 0.000000000000000E+00 z1= 2 -.358701196746455E-05 0.000000000000000E+00 z1= 3 0.155583053553236E-05 0.000000000000000E+00 alpha(00000456)=0.000000000000000E+00 beta (00000457)=0.127298204930840E+02 gamma(00000457)=0.127298204930840E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 457 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000457)=0.000000000000000E+00 beta (00000458)=0.134663517420900E+02 gamma(00000458)=0.134663517420900E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 458 z1= 1 0.110744827027448E-02 0.000000000000000E+00 z1= 2 0.361740527831354E-05 0.000000000000000E+00 z1= 3 -.157641902574920E-05 0.000000000000000E+00 alpha(00000458)=0.000000000000000E+00 beta (00000459)=0.129361034517672E+02 gamma(00000459)=0.129361034517672E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 459 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000459)=0.000000000000000E+00 beta (00000460)=0.134362693098057E+02 gamma(00000460)=0.134362693098057E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 460 z1= 1 -.121700640555271E-02 0.000000000000000E+00 z1= 2 -.371424673451318E-05 0.000000000000000E+00 z1= 3 0.160257434332194E-05 0.000000000000000E+00 alpha(00000460)=0.000000000000000E+00 beta (00000461)=0.127149949115567E+02 gamma(00000461)=0.127149949115567E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 461 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000461)=0.000000000000000E+00 beta (00000462)=0.133073112577846E+02 gamma(00000462)=0.133073112577846E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 462 z1= 1 0.123543122794726E-02 0.000000000000000E+00 z1= 2 0.377721131388561E-05 0.000000000000000E+00 z1= 3 -.163677120358614E-05 0.000000000000000E+00 alpha(00000462)=0.000000000000000E+00 beta (00000463)=0.130288446758394E+02 gamma(00000463)=0.130288446758394E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 463 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000463)=0.000000000000000E+00 beta (00000464)=0.134211066086419E+02 gamma(00000464)=0.134211066086419E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 464 z1= 1 -.114517419475710E-02 0.000000000000000E+00 z1= 2 -.389714173639616E-05 0.000000000000000E+00 z1= 3 0.169531651424192E-05 0.000000000000000E+00 alpha(00000464)=0.000000000000000E+00 beta (00000465)=0.126554435142617E+02 gamma(00000465)=0.126554435142617E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 465 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000465)=0.000000000000000E+00 beta (00000466)=0.134457802317464E+02 gamma(00000466)=0.134457802317464E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 466 z1= 1 0.100085258176513E-02 0.000000000000000E+00 z1= 2 0.388267008028572E-05 0.000000000000000E+00 z1= 3 -.170612321031139E-05 0.000000000000000E+00 alpha(00000466)=0.000000000000000E+00 beta (00000467)=0.128140918120264E+02 gamma(00000467)=0.128140918120264E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 467 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000467)=0.000000000000000E+00 beta (00000468)=0.136873194631174E+02 gamma(00000468)=0.136873194631174E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 468 z1= 1 -.837773068858430E-03 0.000000000000000E+00 z1= 2 -.385430773155657E-05 0.000000000000000E+00 z1= 3 0.169608985968987E-05 0.000000000000000E+00 alpha(00000468)=0.000000000000000E+00 beta (00000469)=0.126931662935652E+02 gamma(00000469)=0.126931662935652E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 469 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000469)=0.000000000000000E+00 beta (00000470)=0.136810340673466E+02 gamma(00000470)=0.136810340673466E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 470 z1= 1 0.603029780009937E-03 0.000000000000000E+00 z1= 2 0.380373454803538E-05 0.000000000000000E+00 z1= 3 -.168181379574771E-05 0.000000000000000E+00 alpha(00000470)=0.000000000000000E+00 beta (00000471)=0.127563526729678E+02 gamma(00000471)=0.127563526729678E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 471 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000471)=0.000000000000000E+00 beta (00000472)=0.133838544216372E+02 gamma(00000472)=0.133838544216372E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 472 z1= 1 -.376735457744868E-03 0.000000000000000E+00 z1= 2 -.385232827655995E-05 0.000000000000000E+00 z1= 3 0.170642450942916E-05 0.000000000000000E+00 alpha(00000472)=0.000000000000000E+00 beta (00000473)=0.126367553213281E+02 gamma(00000473)=0.126367553213281E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 473 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000473)=0.000000000000000E+00 beta (00000474)=0.134964225133256E+02 gamma(00000474)=0.134964225133256E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 474 z1= 1 0.138549868665551E-03 0.000000000000000E+00 z1= 2 0.384656455102578E-05 0.000000000000000E+00 z1= 3 -.170023503953855E-05 0.000000000000000E+00 alpha(00000474)=0.000000000000000E+00 beta (00000475)=0.127392707719931E+02 gamma(00000475)=0.127392707719931E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 475 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000475)=0.000000000000000E+00 beta (00000476)=0.133043198668531E+02 gamma(00000476)=0.133043198668531E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 476 z1= 1 -.366766064946022E-05 0.000000000000000E+00 z1= 2 -.393597855522041E-05 0.000000000000000E+00 z1= 3 0.173681874291300E-05 0.000000000000000E+00 alpha(00000476)=0.000000000000000E+00 beta (00000477)=0.126415206127251E+02 gamma(00000477)=0.126415206127251E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 477 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000477)=0.000000000000000E+00 beta (00000478)=0.133306174541952E+02 gamma(00000478)=0.133306174541952E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 478 z1= 1 -.892032300335082E-04 0.000000000000000E+00 z1= 2 0.400478149081840E-05 0.000000000000000E+00 z1= 3 -.176227297179446E-05 0.000000000000000E+00 alpha(00000478)=0.000000000000000E+00 beta (00000479)=0.126280448310345E+02 gamma(00000479)=0.126280448310345E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 479 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000479)=0.000000000000000E+00 beta (00000480)=0.133935289410988E+02 gamma(00000480)=0.133935289410988E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 480 z1= 1 0.171074197255220E-03 0.000000000000000E+00 z1= 2 -.406042373348944E-05 0.000000000000000E+00 z1= 3 0.178952924324762E-05 0.000000000000000E+00 alpha(00000480)=0.000000000000000E+00 beta (00000481)=0.126439291117072E+02 gamma(00000481)=0.126439291117072E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 481 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000481)=0.000000000000000E+00 beta (00000482)=0.134762709232779E+02 gamma(00000482)=0.134762709232779E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 482 z1= 1 -.274925377297743E-03 0.000000000000000E+00 z1= 2 0.410436959185105E-05 0.000000000000000E+00 z1= 3 -.182160806376714E-05 0.000000000000000E+00 alpha(00000482)=0.000000000000000E+00 beta (00000483)=0.127040134614102E+02 gamma(00000483)=0.127040134614102E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 483 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000483)=0.000000000000000E+00 beta (00000484)=0.136554939522722E+02 gamma(00000484)=0.136554939522722E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 484 z1= 1 0.373545215582915E-03 0.000000000000000E+00 z1= 2 -.411070348120416E-05 0.000000000000000E+00 z1= 3 0.182983376707547E-05 0.000000000000000E+00 alpha(00000484)=0.000000000000000E+00 beta (00000485)=0.126719401506223E+02 gamma(00000485)=0.126719401506223E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 485 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000485)=0.000000000000000E+00 beta (00000486)=0.132368022462890E+02 gamma(00000486)=0.132368022462890E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 486 z1= 1 -.477481808089238E-03 0.000000000000000E+00 z1= 2 0.426980029952445E-05 0.000000000000000E+00 z1= 3 -.189884857320811E-05 0.000000000000000E+00 alpha(00000486)=0.000000000000000E+00 beta (00000487)=0.124437256507087E+02 gamma(00000487)=0.124437256507087E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 487 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000487)=0.000000000000000E+00 beta (00000488)=0.134512616801075E+02 gamma(00000488)=0.134512616801075E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 488 z1= 1 0.507203962256171E-03 0.000000000000000E+00 z1= 2 -.428399820041414E-05 0.000000000000000E+00 z1= 3 0.192127805964527E-05 0.000000000000000E+00 alpha(00000488)=0.000000000000000E+00 beta (00000489)=0.128384062570810E+02 gamma(00000489)=0.128384062570810E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 489 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000489)=0.000000000000000E+00 beta (00000490)=0.132658307660352E+02 gamma(00000490)=0.132658307660352E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 490 z1= 1 -.576552481751443E-03 0.000000000000000E+00 z1= 2 0.450459610865095E-05 0.000000000000000E+00 z1= 3 -.202321591731763E-05 0.000000000000000E+00 alpha(00000490)=0.000000000000000E+00 beta (00000491)=0.125999663666642E+02 gamma(00000491)=0.125999663666642E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 491 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000491)=0.000000000000000E+00 beta (00000492)=0.134509673228159E+02 gamma(00000492)=0.134509673228159E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 492 z1= 1 0.648778494445113E-03 0.000000000000000E+00 z1= 2 -.456359526662784E-05 0.000000000000000E+00 z1= 3 0.206682151953539E-05 0.000000000000000E+00 alpha(00000492)=0.000000000000000E+00 beta (00000493)=0.127242785940630E+02 gamma(00000493)=0.127242785940630E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 493 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000493)=0.000000000000000E+00 beta (00000494)=0.132863276692116E+02 gamma(00000494)=0.132863276692116E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 494 z1= 1 -.798206549711888E-03 0.000000000000000E+00 z1= 2 0.473664903291159E-05 0.000000000000000E+00 z1= 3 -.214869906296312E-05 0.000000000000000E+00 alpha(00000494)=0.000000000000000E+00 beta (00000495)=0.124537550776820E+02 gamma(00000495)=0.124537550776820E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 495 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000495)=0.000000000000000E+00 beta (00000496)=0.134982417785749E+02 gamma(00000496)=0.134982417785749E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 496 z1= 1 0.848248345609175E-03 0.000000000000000E+00 z1= 2 -.471985549351395E-05 0.000000000000000E+00 z1= 3 0.216966278016257E-05 0.000000000000000E+00 alpha(00000496)=0.000000000000000E+00 beta (00000497)=0.128385623256766E+02 gamma(00000497)=0.128385623256766E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 497 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000497)=0.000000000000000E+00 beta (00000498)=0.133352450564169E+02 gamma(00000498)=0.133352450564169E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 498 z1= 1 -.918775332722639E-03 0.000000000000000E+00 z1= 2 0.494101645996366E-05 0.000000000000000E+00 z1= 3 -.225915670947811E-05 0.000000000000000E+00 alpha(00000498)=0.000000000000000E+00 beta (00000499)=0.126817758264412E+02 gamma(00000499)=0.126817758264412E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 499 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000499)=0.000000000000000E+00 beta (00000500)=0.134573929259691E+02 gamma(00000500)=0.134573929259691E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 500 z1= 1 0.105280175071152E-02 0.000000000000000E+00 z1= 2 -.502613189380663E-05 0.000000000000000E+00 z1= 3 0.231648395184443E-05 0.000000000000000E+00 alpha(00000500)=0.000000000000000E+00 beta (00000501)=0.127047233585133E+02 gamma(00000501)=0.127047233585133E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Norm of initial Lanczos vectors= 1.841650183260616 Starting Lanczos loop 2 Lanczos iteration: 1 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal alpha(00000001)=0.000000000000000E+00 beta (00000002)=0.171988457792556E+01 gamma(00000002)=0.171988457792556E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 2 z1= 1 0.317095503346229E-06 0.000000000000000E+00 z1= 2 0.124520367488399E+01 0.000000000000000E+00 z1= 3 -.221874587920010E-05 0.000000000000000E+00 alpha(00000002)=0.000000000000000E+00 beta (00000003)=0.476672365619246E+01 gamma(00000003)=0.476672365619246E+01 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 3 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000003)=0.000000000000000E+00 beta (00000004)=0.135455715795192E+02 gamma(00000004)=0.135455715795192E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 4 z1= 1 -.709927313784567E-07 0.000000000000000E+00 z1= 2 -.355940452122788E+00 0.000000000000000E+00 z1= 3 0.772586761541846E-06 0.000000000000000E+00 alpha(00000004)=0.000000000000000E+00 beta (00000005)=0.127184765807348E+02 gamma(00000005)=0.127184765807348E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 5 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000005)=0.000000000000000E+00 beta (00000006)=0.134778691157450E+02 gamma(00000006)=0.134778691157450E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 6 z1= 1 0.730053106531327E-07 0.000000000000000E+00 z1= 2 0.303457115913058E+00 0.000000000000000E+00 z1= 3 -.747578290290408E-06 0.000000000000000E+00 alpha(00000006)=0.000000000000000E+00 beta (00000007)=0.128879296181110E+02 gamma(00000007)=0.128879296181110E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 7 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000007)=0.000000000000000E+00 beta (00000008)=0.133738547890015E+02 gamma(00000008)=0.133738547890015E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 8 z1= 1 -.816119514679891E-07 0.000000000000000E+00 z1= 2 -.273899857136488E+00 0.000000000000000E+00 z1= 3 0.768114964150616E-06 0.000000000000000E+00 alpha(00000008)=0.000000000000000E+00 beta (00000009)=0.128588178651202E+02 gamma(00000009)=0.128588178651202E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 9 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000009)=0.000000000000000E+00 beta (00000010)=0.134143960269598E+02 gamma(00000010)=0.134143960269598E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 10 z1= 1 0.754291104654650E-07 0.000000000000000E+00 z1= 2 0.250161989698730E+00 0.000000000000000E+00 z1= 3 -.825824189482131E-06 0.000000000000000E+00 alpha(00000010)=0.000000000000000E+00 beta (00000011)=0.128242644456355E+02 gamma(00000011)=0.128242644456355E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 11 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000011)=0.000000000000000E+00 beta (00000012)=0.134762956212125E+02 gamma(00000012)=0.134762956212125E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 12 z1= 1 -.686604815123507E-07 0.000000000000000E+00 z1= 2 -.228558184186962E+00 0.000000000000000E+00 z1= 3 0.921210706231678E-06 0.000000000000000E+00 alpha(00000012)=0.000000000000000E+00 beta (00000013)=0.128064548987133E+02 gamma(00000013)=0.128064548987133E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 13 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000013)=0.000000000000000E+00 beta (00000014)=0.134982181135660E+02 gamma(00000014)=0.134982181135660E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 14 z1= 1 0.779321323624189E-07 0.000000000000000E+00 z1= 2 0.209175570057953E+00 0.000000000000000E+00 z1= 3 -.102980197003481E-05 0.000000000000000E+00 alpha(00000014)=0.000000000000000E+00 beta (00000015)=0.128005733131694E+02 gamma(00000015)=0.128005733131694E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 15 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000015)=0.000000000000000E+00 beta (00000016)=0.134714898429709E+02 gamma(00000016)=0.134714898429709E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 16 z1= 1 -.953430739662406E-07 0.000000000000000E+00 z1= 2 -.192296924630644E+00 0.000000000000000E+00 z1= 3 0.109468522866031E-05 0.000000000000000E+00 alpha(00000016)=0.000000000000000E+00 beta (00000017)=0.127887191118959E+02 gamma(00000017)=0.127887191118959E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 17 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000017)=0.000000000000000E+00 beta (00000018)=0.134266168773043E+02 gamma(00000018)=0.134266168773043E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 18 z1= 1 0.113936581758699E-06 0.000000000000000E+00 z1= 2 0.177688396510926E+00 0.000000000000000E+00 z1= 3 -.113342019171010E-05 0.000000000000000E+00 alpha(00000018)=0.000000000000000E+00 beta (00000019)=0.127825610047418E+02 gamma(00000019)=0.127825610047418E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 19 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000019)=0.000000000000000E+00 beta (00000020)=0.134080222365160E+02 gamma(00000020)=0.134080222365160E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 20 z1= 1 -.146728120586741E-06 0.000000000000000E+00 z1= 2 -.164706537066261E+00 0.000000000000000E+00 z1= 3 0.117792325749817E-05 0.000000000000000E+00 alpha(00000020)=0.000000000000000E+00 beta (00000021)=0.128007392673731E+02 gamma(00000021)=0.128007392673731E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 21 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000021)=0.000000000000000E+00 beta (00000022)=0.134207233641693E+02 gamma(00000022)=0.134207233641693E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 22 z1= 1 0.167024380028080E-06 0.000000000000000E+00 z1= 2 0.153072861491443E+00 0.000000000000000E+00 z1= 3 -.121038059610338E-05 0.000000000000000E+00 alpha(00000022)=0.000000000000000E+00 beta (00000023)=0.128225837684974E+02 gamma(00000023)=0.128225837684974E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 23 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000023)=0.000000000000000E+00 beta (00000024)=0.134332957763461E+02 gamma(00000024)=0.134332957763461E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 24 z1= 1 -.176792557782159E-06 0.000000000000000E+00 z1= 2 -.142653728557131E+00 0.000000000000000E+00 z1= 3 0.123689271855853E-05 0.000000000000000E+00 alpha(00000024)=0.000000000000000E+00 beta (00000025)=0.128311431778952E+02 gamma(00000025)=0.128311431778952E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 25 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000025)=0.000000000000000E+00 beta (00000026)=0.134383831688750E+02 gamma(00000026)=0.134383831688750E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 26 z1= 1 0.183967533524607E-06 0.000000000000000E+00 z1= 2 0.133198658750813E+00 0.000000000000000E+00 z1= 3 -.128095103200937E-05 0.000000000000000E+00 alpha(00000026)=0.000000000000000E+00 beta (00000027)=0.128182273059286E+02 gamma(00000027)=0.128182273059286E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 27 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000027)=0.000000000000000E+00 beta (00000028)=0.134102233713986E+02 gamma(00000028)=0.134102233713986E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 28 z1= 1 -.178608112573302E-06 0.000000000000000E+00 z1= 2 -.124698214154016E+00 0.000000000000000E+00 z1= 3 0.133910004981484E-05 0.000000000000000E+00 alpha(00000028)=0.000000000000000E+00 beta (00000029)=0.127846793859208E+02 gamma(00000029)=0.127846793859208E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 29 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000029)=0.000000000000000E+00 beta (00000030)=0.134134203203856E+02 gamma(00000030)=0.134134203203856E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 30 z1= 1 0.165186359050475E-06 0.000000000000000E+00 z1= 2 0.116544925857030E+00 0.000000000000000E+00 z1= 3 -.138991716440136E-05 0.000000000000000E+00 alpha(00000030)=0.000000000000000E+00 beta (00000031)=0.128191541701642E+02 gamma(00000031)=0.128191541701642E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 31 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000031)=0.000000000000000E+00 beta (00000032)=0.134294004776947E+02 gamma(00000032)=0.134294004776947E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 32 z1= 1 -.148979236850623E-06 0.000000000000000E+00 z1= 2 -.109214402246848E+00 0.000000000000000E+00 z1= 3 0.141910011273473E-05 0.000000000000000E+00 alpha(00000032)=0.000000000000000E+00 beta (00000033)=0.127671189493068E+02 gamma(00000033)=0.127671189493068E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 33 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000033)=0.000000000000000E+00 beta (00000034)=0.133586625210841E+02 gamma(00000034)=0.133586625210841E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 34 z1= 1 0.126877541625769E-06 0.000000000000000E+00 z1= 2 0.102543667188429E+00 0.000000000000000E+00 z1= 3 -.142386086634128E-05 0.000000000000000E+00 alpha(00000034)=0.000000000000000E+00 beta (00000035)=0.127703273146371E+02 gamma(00000035)=0.127703273146371E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 35 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000035)=0.000000000000000E+00 beta (00000036)=0.134311109909508E+02 gamma(00000036)=0.134311109909508E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 36 z1= 1 -.104744958693594E-06 0.000000000000000E+00 z1= 2 -.958468358224083E-01 0.000000000000000E+00 z1= 3 0.143211536812694E-05 0.000000000000000E+00 alpha(00000036)=0.000000000000000E+00 beta (00000037)=0.128060596798497E+02 gamma(00000037)=0.128060596798497E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 37 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000037)=0.000000000000000E+00 beta (00000038)=0.133888964664024E+02 gamma(00000038)=0.133888964664024E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 38 z1= 1 0.873091918710683E-07 0.000000000000000E+00 z1= 2 0.901624865375250E-01 0.000000000000000E+00 z1= 3 -.145885828891506E-05 0.000000000000000E+00 alpha(00000038)=0.000000000000000E+00 beta (00000039)=0.127549640507501E+02 gamma(00000039)=0.127549640507501E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 39 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000039)=0.000000000000000E+00 beta (00000040)=0.133497034707313E+02 gamma(00000040)=0.133497034707313E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 40 z1= 1 -.698951829591204E-07 0.000000000000000E+00 z1= 2 -.847499566110708E-01 0.000000000000000E+00 z1= 3 0.147333903384960E-05 0.000000000000000E+00 alpha(00000040)=0.000000000000000E+00 beta (00000041)=0.126995473557610E+02 gamma(00000041)=0.126995473557610E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 41 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000041)=0.000000000000000E+00 beta (00000042)=0.133246755218828E+02 gamma(00000042)=0.133246755218828E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 42 z1= 1 0.498886619888436E-07 0.000000000000000E+00 z1= 2 0.794594828241172E-01 0.000000000000000E+00 z1= 3 -.147649236684200E-05 0.000000000000000E+00 alpha(00000042)=0.000000000000000E+00 beta (00000043)=0.127528433245273E+02 gamma(00000043)=0.127528433245273E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 43 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000043)=0.000000000000000E+00 beta (00000044)=0.133691964249925E+02 gamma(00000044)=0.133691964249925E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 44 z1= 1 -.292861221853208E-07 0.000000000000000E+00 z1= 2 -.746051735512792E-01 0.000000000000000E+00 z1= 3 0.148749159504320E-05 0.000000000000000E+00 alpha(00000044)=0.000000000000000E+00 beta (00000045)=0.127653057078416E+02 gamma(00000045)=0.127653057078416E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 45 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000045)=0.000000000000000E+00 beta (00000046)=0.134072282335253E+02 gamma(00000046)=0.134072282335253E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 46 z1= 1 0.171701336100505E-07 0.000000000000000E+00 z1= 2 0.699090961293279E-01 0.000000000000000E+00 z1= 3 -.148317952237357E-05 0.000000000000000E+00 alpha(00000046)=0.000000000000000E+00 beta (00000047)=0.127671148415383E+02 gamma(00000047)=0.127671148415383E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 47 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000047)=0.000000000000000E+00 beta (00000048)=0.133557565416867E+02 gamma(00000048)=0.133557565416867E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 48 z1= 1 -.169327510255411E-07 0.000000000000000E+00 z1= 2 -.657699116567064E-01 0.000000000000000E+00 z1= 3 0.147122826496104E-05 0.000000000000000E+00 alpha(00000048)=0.000000000000000E+00 beta (00000049)=0.128436227860017E+02 gamma(00000049)=0.128436227860017E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 49 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000049)=0.000000000000000E+00 beta (00000050)=0.134358300740148E+02 gamma(00000050)=0.134358300740148E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 50 z1= 1 0.248542599695645E-07 0.000000000000000E+00 z1= 2 0.619291916488800E-01 0.000000000000000E+00 z1= 3 -.145165333555750E-05 0.000000000000000E+00 alpha(00000050)=0.000000000000000E+00 beta (00000051)=0.126967571136032E+02 gamma(00000051)=0.126967571136032E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 51 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000051)=0.000000000000000E+00 beta (00000052)=0.132891106491037E+02 gamma(00000052)=0.132891106491037E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 52 z1= 1 -.378481225847896E-07 0.000000000000000E+00 z1= 2 -.582335685689649E-01 0.000000000000000E+00 z1= 3 0.143065189191736E-05 0.000000000000000E+00 alpha(00000052)=0.000000000000000E+00 beta (00000053)=0.127443368135094E+02 gamma(00000053)=0.127443368135094E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 53 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000053)=0.000000000000000E+00 beta (00000054)=0.133131464859936E+02 gamma(00000054)=0.133131464859936E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 54 z1= 1 0.461469937388694E-07 0.000000000000000E+00 z1= 2 0.549113560100973E-01 0.000000000000000E+00 z1= 3 -.141730531457904E-05 0.000000000000000E+00 alpha(00000054)=0.000000000000000E+00 beta (00000055)=0.127443548004699E+02 gamma(00000055)=0.127443548004699E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 55 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000055)=0.000000000000000E+00 beta (00000056)=0.133785371460162E+02 gamma(00000056)=0.133785371460162E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 56 z1= 1 -.679880394933996E-07 0.000000000000000E+00 z1= 2 -.515461109741360E-01 0.000000000000000E+00 z1= 3 0.140524007826489E-05 0.000000000000000E+00 alpha(00000056)=0.000000000000000E+00 beta (00000057)=0.128320518144718E+02 gamma(00000057)=0.128320518144718E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 57 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000057)=0.000000000000000E+00 beta (00000058)=0.134459852093295E+02 gamma(00000058)=0.134459852093295E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 58 z1= 1 0.919901273644524E-07 0.000000000000000E+00 z1= 2 0.484731575399201E-01 0.000000000000000E+00 z1= 3 -.139602262563842E-05 0.000000000000000E+00 alpha(00000058)=0.000000000000000E+00 beta (00000059)=0.127464079340228E+02 gamma(00000059)=0.127464079340228E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 59 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000059)=0.000000000000000E+00 beta (00000060)=0.133328229368031E+02 gamma(00000060)=0.133328229368031E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 60 z1= 1 -.109058690841990E-06 0.000000000000000E+00 z1= 2 -.457060886903577E-01 0.000000000000000E+00 z1= 3 0.138723136445000E-05 0.000000000000000E+00 alpha(00000060)=0.000000000000000E+00 beta (00000061)=0.128405797712576E+02 gamma(00000061)=0.128405797712576E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 61 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000061)=0.000000000000000E+00 beta (00000062)=0.133760307587134E+02 gamma(00000062)=0.133760307587134E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 62 z1= 1 0.119607928896273E-06 0.000000000000000E+00 z1= 2 0.432737522187715E-01 0.000000000000000E+00 z1= 3 -.138486525455930E-05 0.000000000000000E+00 alpha(00000062)=0.000000000000000E+00 beta (00000063)=0.128441833817929E+02 gamma(00000063)=0.128441833817929E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 63 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000063)=0.000000000000000E+00 beta (00000064)=0.134459511560684E+02 gamma(00000064)=0.134459511560684E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 64 z1= 1 -.131302126016048E-06 0.000000000000000E+00 z1= 2 -.408085549129928E-01 0.000000000000000E+00 z1= 3 0.137677668728294E-05 0.000000000000000E+00 alpha(00000064)=0.000000000000000E+00 beta (00000065)=0.128237682408645E+02 gamma(00000065)=0.128237682408645E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 65 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000065)=0.000000000000000E+00 beta (00000066)=0.134804252917022E+02 gamma(00000066)=0.134804252917022E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 66 z1= 1 0.149661052043903E-06 0.000000000000000E+00 z1= 2 0.383600758947138E-01 0.000000000000000E+00 z1= 3 -.136590048857848E-05 0.000000000000000E+00 alpha(00000066)=0.000000000000000E+00 beta (00000067)=0.128621052138649E+02 gamma(00000067)=0.128621052138649E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 67 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000067)=0.000000000000000E+00 beta (00000068)=0.133881810374547E+02 gamma(00000068)=0.133881810374547E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 68 z1= 1 -.163525421744814E-06 0.000000000000000E+00 z1= 2 -.364112629135434E-01 0.000000000000000E+00 z1= 3 0.136798831157706E-05 0.000000000000000E+00 alpha(00000068)=0.000000000000000E+00 beta (00000069)=0.128152881081528E+02 gamma(00000069)=0.128152881081528E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 69 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000069)=0.000000000000000E+00 beta (00000070)=0.133445162234548E+02 gamma(00000070)=0.133445162234548E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 70 z1= 1 0.173594029687215E-06 0.000000000000000E+00 z1= 2 0.345810617992865E-01 0.000000000000000E+00 z1= 3 -.137036961219599E-05 0.000000000000000E+00 alpha(00000070)=0.000000000000000E+00 beta (00000071)=0.128069654390537E+02 gamma(00000071)=0.128069654390537E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 71 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000071)=0.000000000000000E+00 beta (00000072)=0.134042175660074E+02 gamma(00000072)=0.134042175660074E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 72 z1= 1 -.178560118785538E-06 0.000000000000000E+00 z1= 2 -.326967507624420E-01 0.000000000000000E+00 z1= 3 0.137764026259337E-05 0.000000000000000E+00 alpha(00000072)=0.000000000000000E+00 beta (00000073)=0.128627103435083E+02 gamma(00000073)=0.128627103435083E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 73 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000073)=0.000000000000000E+00 beta (00000074)=0.133230421565322E+02 gamma(00000074)=0.133230421565322E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 74 z1= 1 0.184907377091294E-06 0.000000000000000E+00 z1= 2 0.313036663230153E-01 0.000000000000000E+00 z1= 3 -.139086514727791E-05 0.000000000000000E+00 alpha(00000074)=0.000000000000000E+00 beta (00000075)=0.127141926236090E+02 gamma(00000075)=0.127141926236090E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 75 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000075)=0.000000000000000E+00 beta (00000076)=0.133868799514664E+02 gamma(00000076)=0.133868799514664E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 76 z1= 1 -.193991818937204E-06 0.000000000000000E+00 z1= 2 -.294637377373356E-01 0.000000000000000E+00 z1= 3 0.138195377978655E-05 0.000000000000000E+00 alpha(00000076)=0.000000000000000E+00 beta (00000077)=0.127641760166157E+02 gamma(00000077)=0.127641760166157E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 77 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000077)=0.000000000000000E+00 beta (00000078)=0.133755111186527E+02 gamma(00000078)=0.133755111186527E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 78 z1= 1 0.212422084499599E-06 0.000000000000000E+00 z1= 2 0.278746852743967E-01 0.000000000000000E+00 z1= 3 -.138139065226158E-05 0.000000000000000E+00 alpha(00000078)=0.000000000000000E+00 beta (00000079)=0.128262846599938E+02 gamma(00000079)=0.128262846599938E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 79 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000079)=0.000000000000000E+00 beta (00000080)=0.133316309140939E+02 gamma(00000080)=0.133316309140939E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 80 z1= 1 -.238116441914765E-06 0.000000000000000E+00 z1= 2 -.266560706334089E-01 0.000000000000000E+00 z1= 3 0.138883427769733E-05 0.000000000000000E+00 alpha(00000080)=0.000000000000000E+00 beta (00000081)=0.127857315191969E+02 gamma(00000081)=0.127857315191969E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 81 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000081)=0.000000000000000E+00 beta (00000082)=0.133994485616234E+02 gamma(00000082)=0.133994485616234E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 82 z1= 1 0.261379095076175E-06 0.000000000000000E+00 z1= 2 0.253065704606500E-01 0.000000000000000E+00 z1= 3 -.138007917961614E-05 0.000000000000000E+00 alpha(00000082)=0.000000000000000E+00 beta (00000083)=0.128396988936722E+02 gamma(00000083)=0.128396988936722E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 83 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000083)=0.000000000000000E+00 beta (00000084)=0.133717655748668E+02 gamma(00000084)=0.133717655748668E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 84 z1= 1 -.299694735311426E-06 0.000000000000000E+00 z1= 2 -.241731604964774E-01 0.000000000000000E+00 z1= 3 0.139771944255543E-05 0.000000000000000E+00 alpha(00000084)=0.000000000000000E+00 beta (00000085)=0.128117722162302E+02 gamma(00000085)=0.128117722162302E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 85 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000085)=0.000000000000000E+00 beta (00000086)=0.133218183651525E+02 gamma(00000086)=0.133218183651525E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 86 z1= 1 0.339226551236346E-06 0.000000000000000E+00 z1= 2 0.231491536005950E-01 0.000000000000000E+00 z1= 3 -.140894538631421E-05 0.000000000000000E+00 alpha(00000086)=0.000000000000000E+00 beta (00000087)=0.127545874553951E+02 gamma(00000087)=0.127545874553951E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 87 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000087)=0.000000000000000E+00 beta (00000088)=0.133435620186961E+02 gamma(00000088)=0.133435620186961E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 88 z1= 1 -.372445508644952E-06 0.000000000000000E+00 z1= 2 -.220543469972217E-01 0.000000000000000E+00 z1= 3 0.142933213310742E-05 0.000000000000000E+00 alpha(00000088)=0.000000000000000E+00 beta (00000089)=0.128929975471714E+02 gamma(00000089)=0.128929975471714E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 89 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000089)=0.000000000000000E+00 beta (00000090)=0.133924346230501E+02 gamma(00000090)=0.133924346230501E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 90 z1= 1 0.407696640183919E-06 0.000000000000000E+00 z1= 2 0.211833571167313E-01 0.000000000000000E+00 z1= 3 -.145124077793012E-05 0.000000000000000E+00 alpha(00000090)=0.000000000000000E+00 beta (00000091)=0.126659757914214E+02 gamma(00000091)=0.126659757914214E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 91 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000091)=0.000000000000000E+00 beta (00000092)=0.133458518882292E+02 gamma(00000092)=0.133458518882292E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 92 z1= 1 -.422207161879587E-06 0.000000000000000E+00 z1= 2 -.200864253774463E-01 0.000000000000000E+00 z1= 3 0.143193876756646E-05 0.000000000000000E+00 alpha(00000092)=0.000000000000000E+00 beta (00000093)=0.127909393086097E+02 gamma(00000093)=0.127909393086097E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 93 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000093)=0.000000000000000E+00 beta (00000094)=0.133461372887160E+02 gamma(00000094)=0.133461372887160E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 94 z1= 1 0.451993989596632E-06 0.000000000000000E+00 z1= 2 0.192790328978661E-01 0.000000000000000E+00 z1= 3 -.142333575930900E-05 0.000000000000000E+00 alpha(00000094)=0.000000000000000E+00 beta (00000095)=0.127865790361712E+02 gamma(00000095)=0.127865790361712E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 95 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000095)=0.000000000000000E+00 beta (00000096)=0.133901025233023E+02 gamma(00000096)=0.133901025233023E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 96 z1= 1 -.478290603350348E-06 0.000000000000000E+00 z1= 2 -.184170333309770E-01 0.000000000000000E+00 z1= 3 0.140676661283801E-05 0.000000000000000E+00 alpha(00000096)=0.000000000000000E+00 beta (00000097)=0.127921040309578E+02 gamma(00000097)=0.127921040309578E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 97 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000097)=0.000000000000000E+00 beta (00000098)=0.134509429182819E+02 gamma(00000098)=0.134509429182819E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 98 z1= 1 0.494522844262432E-06 0.000000000000000E+00 z1= 2 0.175091771023050E-01 0.000000000000000E+00 z1= 3 -.138281774661643E-05 0.000000000000000E+00 alpha(00000098)=0.000000000000000E+00 beta (00000099)=0.130150737030773E+02 gamma(00000099)=0.130150737030773E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 99 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000099)=0.000000000000000E+00 beta (00000100)=0.136149118803897E+02 gamma(00000100)=0.136149118803897E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 100 z1= 1 -.515944330635584E-06 0.000000000000000E+00 z1= 2 -.167547814377519E-01 0.000000000000000E+00 z1= 3 0.135140861642918E-05 0.000000000000000E+00 alpha(00000100)=0.000000000000000E+00 beta (00000101)=0.127969530262333E+02 gamma(00000101)=0.127969530262333E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 101 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000101)=0.000000000000000E+00 beta (00000102)=0.132882473664145E+02 gamma(00000102)=0.132882473664145E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 102 z1= 1 0.541037656784978E-06 0.000000000000000E+00 z1= 2 0.161799091177460E-01 0.000000000000000E+00 z1= 3 -.132541389902046E-05 0.000000000000000E+00 alpha(00000102)=0.000000000000000E+00 beta (00000103)=0.128815671989160E+02 gamma(00000103)=0.128815671989160E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 103 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000103)=0.000000000000000E+00 beta (00000104)=0.134147783842160E+02 gamma(00000104)=0.134147783842160E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 104 z1= 1 -.562748091265759E-06 0.000000000000000E+00 z1= 2 -.156274762717688E-01 0.000000000000000E+00 z1= 3 0.130035414217335E-05 0.000000000000000E+00 alpha(00000104)=0.000000000000000E+00 beta (00000105)=0.128778630469479E+02 gamma(00000105)=0.128778630469479E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 105 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000105)=0.000000000000000E+00 beta (00000106)=0.132659039721740E+02 gamma(00000106)=0.132659039721740E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 106 z1= 1 0.593544908862728E-06 0.000000000000000E+00 z1= 2 0.152720209886075E-01 0.000000000000000E+00 z1= 3 -.129754339370095E-05 0.000000000000000E+00 alpha(00000106)=0.000000000000000E+00 beta (00000107)=0.126949441298188E+02 gamma(00000107)=0.126949441298188E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 107 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000107)=0.000000000000000E+00 beta (00000108)=0.133395828396943E+02 gamma(00000108)=0.133395828396943E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 108 z1= 1 -.620124458342291E-06 0.000000000000000E+00 z1= 2 -.145900525657302E-01 0.000000000000000E+00 z1= 3 0.126921295439840E-05 0.000000000000000E+00 alpha(00000108)=0.000000000000000E+00 beta (00000109)=0.128482733291928E+02 gamma(00000109)=0.128482733291928E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 109 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000109)=0.000000000000000E+00 beta (00000110)=0.133217672248390E+02 gamma(00000110)=0.133217672248390E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 110 z1= 1 0.654445692239080E-06 0.000000000000000E+00 z1= 2 0.141245704249187E-01 0.000000000000000E+00 z1= 3 -.124051828349404E-05 0.000000000000000E+00 alpha(00000110)=0.000000000000000E+00 beta (00000111)=0.126967111362054E+02 gamma(00000111)=0.126967111362054E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 111 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000111)=0.000000000000000E+00 beta (00000112)=0.135206919879961E+02 gamma(00000112)=0.135206919879961E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 112 z1= 1 -.682143865366348E-06 0.000000000000000E+00 z1= 2 -.133228025881830E-01 0.000000000000000E+00 z1= 3 0.118177153908409E-05 0.000000000000000E+00 alpha(00000112)=0.000000000000000E+00 beta (00000113)=0.129787482073338E+02 gamma(00000113)=0.129787482073338E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 113 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000113)=0.000000000000000E+00 beta (00000114)=0.134371977380927E+02 gamma(00000114)=0.134371977380927E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 114 z1= 1 0.730488856749570E-06 0.000000000000000E+00 z1= 2 0.129010829180915E-01 0.000000000000000E+00 z1= 3 -.115227312497178E-05 0.000000000000000E+00 alpha(00000114)=0.000000000000000E+00 beta (00000115)=0.127033480997902E+02 gamma(00000115)=0.127033480997902E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 115 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000115)=0.000000000000000E+00 beta (00000116)=0.135069839916071E+02 gamma(00000116)=0.135069839916071E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 116 z1= 1 -.761276688108136E-06 0.000000000000000E+00 z1= 2 -.122154973439061E-01 0.000000000000000E+00 z1= 3 0.108452864458800E-05 0.000000000000000E+00 alpha(00000116)=0.000000000000000E+00 beta (00000117)=0.127083365075967E+02 gamma(00000117)=0.127083365075967E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 117 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000117)=0.000000000000000E+00 beta (00000118)=0.132506525370431E+02 gamma(00000118)=0.132506525370431E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 118 z1= 1 0.814196278609925E-06 0.000000000000000E+00 z1= 2 0.118297492061078E-01 0.000000000000000E+00 z1= 3 -.103772403622438E-05 0.000000000000000E+00 alpha(00000118)=0.000000000000000E+00 beta (00000119)=0.127948300566571E+02 gamma(00000119)=0.127948300566571E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 119 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000119)=0.000000000000000E+00 beta (00000120)=0.133198411447122E+02 gamma(00000120)=0.133198411447122E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 120 z1= 1 -.855745037019184E-06 0.000000000000000E+00 z1= 2 -.114615360332153E-01 0.000000000000000E+00 z1= 3 0.995054258216355E-06 0.000000000000000E+00 alpha(00000120)=0.000000000000000E+00 beta (00000121)=0.125251023324571E+02 gamma(00000121)=0.125251023324571E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 121 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000121)=0.000000000000000E+00 beta (00000122)=0.131931010122391E+02 gamma(00000122)=0.131931010122391E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 122 z1= 1 0.883531032879695E-06 0.000000000000000E+00 z1= 2 0.109867869934768E-01 0.000000000000000E+00 z1= 3 -.936637162692608E-06 0.000000000000000E+00 alpha(00000122)=0.000000000000000E+00 beta (00000123)=0.127053174545164E+02 gamma(00000123)=0.127053174545164E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 123 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000123)=0.000000000000000E+00 beta (00000124)=0.133819599718688E+02 gamma(00000124)=0.133819599718688E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 124 z1= 1 -.911042491655517E-06 0.000000000000000E+00 z1= 2 -.105063759919598E-01 0.000000000000000E+00 z1= 3 0.868062535213016E-06 0.000000000000000E+00 alpha(00000124)=0.000000000000000E+00 beta (00000125)=0.126842079454632E+02 gamma(00000125)=0.126842079454632E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 125 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000125)=0.000000000000000E+00 beta (00000126)=0.133805664687447E+02 gamma(00000126)=0.133805664687447E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 126 z1= 1 0.935578643005992E-06 0.000000000000000E+00 z1= 2 0.100407847093536E-01 0.000000000000000E+00 z1= 3 -.800555838431291E-06 0.000000000000000E+00 alpha(00000126)=0.000000000000000E+00 beta (00000127)=0.128061204619817E+02 gamma(00000127)=0.128061204619817E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 127 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000127)=0.000000000000000E+00 beta (00000128)=0.132907880569990E+02 gamma(00000128)=0.132907880569990E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 128 z1= 1 -.975654113411720E-06 0.000000000000000E+00 z1= 2 -.973660483386434E-02 0.000000000000000E+00 z1= 3 0.745895181534281E-06 0.000000000000000E+00 alpha(00000128)=0.000000000000000E+00 beta (00000129)=0.127747966685744E+02 gamma(00000129)=0.127747966685744E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 129 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000129)=0.000000000000000E+00 beta (00000130)=0.132951250145243E+02 gamma(00000130)=0.132951250145243E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 130 z1= 1 0.100437339109602E-05 0.000000000000000E+00 z1= 2 0.941463236472839E-02 0.000000000000000E+00 z1= 3 -.677406628535890E-06 0.000000000000000E+00 alpha(00000130)=0.000000000000000E+00 beta (00000131)=0.127446356688777E+02 gamma(00000131)=0.127446356688777E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 131 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000131)=0.000000000000000E+00 beta (00000132)=0.131433426333794E+02 gamma(00000132)=0.131433426333794E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 132 z1= 1 -.103247959823633E-05 0.000000000000000E+00 z1= 2 -.917804786629992E-02 0.000000000000000E+00 z1= 3 0.604218852652549E-06 0.000000000000000E+00 alpha(00000132)=0.000000000000000E+00 beta (00000133)=0.127576292684171E+02 gamma(00000133)=0.127576292684171E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 133 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000133)=0.000000000000000E+00 beta (00000134)=0.134670380404582E+02 gamma(00000134)=0.134670380404582E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 134 z1= 1 0.102849093916359E-05 0.000000000000000E+00 z1= 2 0.869350866361398E-02 0.000000000000000E+00 z1= 3 -.518605317934907E-06 0.000000000000000E+00 alpha(00000134)=0.000000000000000E+00 beta (00000135)=0.127762132248046E+02 gamma(00000135)=0.127762132248046E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 135 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000135)=0.000000000000000E+00 beta (00000136)=0.134260226782820E+02 gamma(00000136)=0.134260226782820E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 136 z1= 1 -.102584878773973E-05 0.000000000000000E+00 z1= 2 -.830312207588573E-02 0.000000000000000E+00 z1= 3 0.433753785011393E-06 0.000000000000000E+00 alpha(00000136)=0.000000000000000E+00 beta (00000137)=0.129114184456332E+02 gamma(00000137)=0.129114184456332E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 137 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000137)=0.000000000000000E+00 beta (00000138)=0.133836379120135E+02 gamma(00000138)=0.133836379120135E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 138 z1= 1 0.103366617286047E-05 0.000000000000000E+00 z1= 2 0.809071070514883E-02 0.000000000000000E+00 z1= 3 -.364009874781479E-06 0.000000000000000E+00 alpha(00000138)=0.000000000000000E+00 beta (00000139)=0.129445319033460E+02 gamma(00000139)=0.129445319033460E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 139 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000139)=0.000000000000000E+00 beta (00000140)=0.135470965860482E+02 gamma(00000140)=0.135470965860482E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 140 z1= 1 -.103779878763343E-05 0.000000000000000E+00 z1= 2 -.782226028085625E-02 0.000000000000000E+00 z1= 3 0.296632566743369E-06 0.000000000000000E+00 alpha(00000140)=0.000000000000000E+00 beta (00000141)=0.127278504636548E+02 gamma(00000141)=0.127278504636548E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 141 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000141)=0.000000000000000E+00 beta (00000142)=0.134909219977230E+02 gamma(00000142)=0.134909219977230E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 142 z1= 1 0.103218787497771E-05 0.000000000000000E+00 z1= 2 0.747261402129886E-02 0.000000000000000E+00 z1= 3 -.211168278339561E-06 0.000000000000000E+00 alpha(00000142)=0.000000000000000E+00 beta (00000143)=0.127388173235863E+02 gamma(00000143)=0.127388173235863E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 143 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000143)=0.000000000000000E+00 beta (00000144)=0.134409852480717E+02 gamma(00000144)=0.134409852480717E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 144 z1= 1 -.103565262227386E-05 0.000000000000000E+00 z1= 2 -.714991515082834E-02 0.000000000000000E+00 z1= 3 0.144201465746610E-06 0.000000000000000E+00 alpha(00000144)=0.000000000000000E+00 beta (00000145)=0.129263364384594E+02 gamma(00000145)=0.129263364384594E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 145 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000145)=0.000000000000000E+00 beta (00000146)=0.133955208992933E+02 gamma(00000146)=0.133955208992933E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 146 z1= 1 0.105951222333892E-05 0.000000000000000E+00 z1= 2 0.694935720809958E-02 0.000000000000000E+00 z1= 3 -.825981350774277E-07 0.000000000000000E+00 alpha(00000146)=0.000000000000000E+00 beta (00000147)=0.128294766287082E+02 gamma(00000147)=0.128294766287082E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 147 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000147)=0.000000000000000E+00 beta (00000148)=0.136375174458535E+02 gamma(00000148)=0.136375174458535E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 148 z1= 1 -.105904615362918E-05 0.000000000000000E+00 z1= 2 -.656973454849849E-02 0.000000000000000E+00 z1= 3 0.312275559188240E-07 0.000000000000000E+00 alpha(00000148)=0.000000000000000E+00 beta (00000149)=0.127203037165633E+02 gamma(00000149)=0.127203037165633E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 149 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000149)=0.000000000000000E+00 beta (00000150)=0.135407488726473E+02 gamma(00000150)=0.135407488726473E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 150 z1= 1 0.106239516298070E-05 0.000000000000000E+00 z1= 2 0.618147335007543E-02 0.000000000000000E+00 z1= 3 0.294653150650936E-07 0.000000000000000E+00 alpha(00000150)=0.000000000000000E+00 beta (00000151)=0.126679041497047E+02 gamma(00000151)=0.126679041497047E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 151 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000151)=0.000000000000000E+00 beta (00000152)=0.134957579036312E+02 gamma(00000152)=0.134957579036312E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 152 z1= 1 -.105917121673857E-05 0.000000000000000E+00 z1= 2 -.579877918204266E-02 0.000000000000000E+00 z1= 3 -.828648795436239E-07 0.000000000000000E+00 alpha(00000152)=0.000000000000000E+00 beta (00000153)=0.125471913599242E+02 gamma(00000153)=0.125471913599242E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 153 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000153)=0.000000000000000E+00 beta (00000154)=0.132884917450183E+02 gamma(00000154)=0.132884917450183E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 154 z1= 1 0.105818799361456E-05 0.000000000000000E+00 z1= 2 0.545214156660806E-02 0.000000000000000E+00 z1= 3 0.142514987836568E-06 0.000000000000000E+00 alpha(00000154)=0.000000000000000E+00 beta (00000155)=0.128413064816161E+02 gamma(00000155)=0.128413064816161E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 155 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000155)=0.000000000000000E+00 beta (00000156)=0.133879555574154E+02 gamma(00000156)=0.133879555574154E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 156 z1= 1 -.107590433559134E-05 0.000000000000000E+00 z1= 2 -.518976300996476E-02 0.000000000000000E+00 z1= 3 -.195539046567834E-06 0.000000000000000E+00 alpha(00000156)=0.000000000000000E+00 beta (00000157)=0.128086748716001E+02 gamma(00000157)=0.128086748716001E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 157 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000157)=0.000000000000000E+00 beta (00000158)=0.135343390145841E+02 gamma(00000158)=0.135343390145841E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 158 z1= 1 0.107946078301783E-05 0.000000000000000E+00 z1= 2 0.482107913855394E-02 0.000000000000000E+00 z1= 3 0.248970499216420E-06 0.000000000000000E+00 alpha(00000158)=0.000000000000000E+00 beta (00000159)=0.127047546512039E+02 gamma(00000159)=0.127047546512039E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 159 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000159)=0.000000000000000E+00 beta (00000160)=0.132659523055967E+02 gamma(00000160)=0.132659523055967E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 160 z1= 1 -.108928314458689E-05 0.000000000000000E+00 z1= 2 -.451839380304038E-02 0.000000000000000E+00 z1= 3 -.313553387191020E-06 0.000000000000000E+00 alpha(00000160)=0.000000000000000E+00 beta (00000161)=0.125635431020473E+02 gamma(00000161)=0.125635431020473E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 161 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000161)=0.000000000000000E+00 beta (00000162)=0.133039659354947E+02 gamma(00000162)=0.133039659354947E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 162 z1= 1 0.107236647758913E-05 0.000000000000000E+00 z1= 2 0.422995649584881E-02 0.000000000000000E+00 z1= 3 0.380006947690680E-06 0.000000000000000E+00 alpha(00000162)=0.000000000000000E+00 beta (00000163)=0.127494997661192E+02 gamma(00000163)=0.127494997661192E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 163 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000163)=0.000000000000000E+00 beta (00000164)=0.131751258900873E+02 gamma(00000164)=0.131751258900873E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 164 z1= 1 -.107931879048378E-05 0.000000000000000E+00 z1= 2 -.411027507129953E-02 0.000000000000000E+00 z1= 3 -.447163887185497E-06 0.000000000000000E+00 alpha(00000164)=0.000000000000000E+00 beta (00000165)=0.126038859000492E+02 gamma(00000165)=0.126038859000492E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 165 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000165)=0.000000000000000E+00 beta (00000166)=0.134358658212613E+02 gamma(00000166)=0.134358658212613E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 166 z1= 1 0.106351077201966E-05 0.000000000000000E+00 z1= 2 0.389749775070855E-02 0.000000000000000E+00 z1= 3 0.491409726466004E-06 0.000000000000000E+00 alpha(00000166)=0.000000000000000E+00 beta (00000167)=0.127184558380648E+02 gamma(00000167)=0.127184558380648E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 167 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000167)=0.000000000000000E+00 beta (00000168)=0.134466489729254E+02 gamma(00000168)=0.134466489729254E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 168 z1= 1 -.106860015988176E-05 0.000000000000000E+00 z1= 2 -.379400611101051E-02 0.000000000000000E+00 z1= 3 -.530242690438841E-06 0.000000000000000E+00 alpha(00000168)=0.000000000000000E+00 beta (00000169)=0.127723839590025E+02 gamma(00000169)=0.127723839590025E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 169 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000169)=0.000000000000000E+00 beta (00000170)=0.132923294616541E+02 gamma(00000170)=0.132923294616541E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 170 z1= 1 0.108191530806068E-05 0.000000000000000E+00 z1= 2 0.375436808835560E-02 0.000000000000000E+00 z1= 3 0.577796892553876E-06 0.000000000000000E+00 alpha(00000170)=0.000000000000000E+00 beta (00000171)=0.127568568816318E+02 gamma(00000171)=0.127568568816318E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 171 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000171)=0.000000000000000E+00 beta (00000172)=0.133681871406868E+02 gamma(00000172)=0.133681871406868E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 172 z1= 1 -.108819182292148E-05 0.000000000000000E+00 z1= 2 -.371256182696771E-02 0.000000000000000E+00 z1= 3 -.634886751288508E-06 0.000000000000000E+00 alpha(00000172)=0.000000000000000E+00 beta (00000173)=0.127960423053282E+02 gamma(00000173)=0.127960423053282E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 173 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000173)=0.000000000000000E+00 beta (00000174)=0.134741881015547E+02 gamma(00000174)=0.134741881015547E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 174 z1= 1 0.109239239843390E-05 0.000000000000000E+00 z1= 2 0.357095355852630E-02 0.000000000000000E+00 z1= 3 0.681469873070563E-06 0.000000000000000E+00 alpha(00000174)=0.000000000000000E+00 beta (00000175)=0.128361174105512E+02 gamma(00000175)=0.128361174105512E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 175 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000175)=0.000000000000000E+00 beta (00000176)=0.133955757010337E+02 gamma(00000176)=0.133955757010337E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 176 z1= 1 -.110311230164814E-05 0.000000000000000E+00 z1= 2 -.335493968454716E-02 0.000000000000000E+00 z1= 3 -.739446794686786E-06 0.000000000000000E+00 alpha(00000176)=0.000000000000000E+00 beta (00000177)=0.127371852541013E+02 gamma(00000177)=0.127371852541013E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 177 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000177)=0.000000000000000E+00 beta (00000178)=0.133609366177205E+02 gamma(00000178)=0.133609366177205E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 178 z1= 1 0.111885057118687E-05 0.000000000000000E+00 z1= 2 0.312200218431379E-02 0.000000000000000E+00 z1= 3 0.791271319925877E-06 0.000000000000000E+00 alpha(00000178)=0.000000000000000E+00 beta (00000179)=0.126228657734582E+02 gamma(00000179)=0.126228657734582E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 179 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000179)=0.000000000000000E+00 beta (00000180)=0.134189404990344E+02 gamma(00000180)=0.134189404990344E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 180 z1= 1 -.111730974403004E-05 0.000000000000000E+00 z1= 2 -.280505210291405E-02 0.000000000000000E+00 z1= 3 -.847025019017240E-06 0.000000000000000E+00 alpha(00000180)=0.000000000000000E+00 beta (00000181)=0.127642316802466E+02 gamma(00000181)=0.127642316802466E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 181 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000181)=0.000000000000000E+00 beta (00000182)=0.134409141429390E+02 gamma(00000182)=0.134409141429390E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 182 z1= 1 0.112232772496923E-05 0.000000000000000E+00 z1= 2 0.252770498377594E-02 0.000000000000000E+00 z1= 3 0.910795989597169E-06 0.000000000000000E+00 alpha(00000182)=0.000000000000000E+00 beta (00000183)=0.128179025753085E+02 gamma(00000183)=0.128179025753085E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 183 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000183)=0.000000000000000E+00 beta (00000184)=0.135090366548233E+02 gamma(00000184)=0.135090366548233E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 184 z1= 1 -.111687856092476E-05 0.000000000000000E+00 z1= 2 -.229158041477047E-02 0.000000000000000E+00 z1= 3 -.984247161710467E-06 0.000000000000000E+00 alpha(00000184)=0.000000000000000E+00 beta (00000185)=0.129152285336588E+02 gamma(00000185)=0.129152285336588E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 185 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000185)=0.000000000000000E+00 beta (00000186)=0.133109443639838E+02 gamma(00000186)=0.133109443639838E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 186 z1= 1 0.113063033166556E-05 0.000000000000000E+00 z1= 2 0.208359887777609E-02 0.000000000000000E+00 z1= 3 0.107145512976423E-05 0.000000000000000E+00 alpha(00000186)=0.000000000000000E+00 beta (00000187)=0.127266820868849E+02 gamma(00000187)=0.127266820868849E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 187 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000187)=0.000000000000000E+00 beta (00000188)=0.134537882143667E+02 gamma(00000188)=0.134537882143667E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 188 z1= 1 -.110250468056232E-05 0.000000000000000E+00 z1= 2 -.185796026025172E-02 0.000000000000000E+00 z1= 3 -.113343429432875E-05 0.000000000000000E+00 alpha(00000188)=0.000000000000000E+00 beta (00000189)=0.129513207015717E+02 gamma(00000189)=0.129513207015717E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 189 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000189)=0.000000000000000E+00 beta (00000190)=0.137067210021585E+02 gamma(00000190)=0.137067210021585E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 190 z1= 1 0.107499442737009E-05 0.000000000000000E+00 z1= 2 0.163471384436023E-02 0.000000000000000E+00 z1= 3 0.116534852662956E-05 0.000000000000000E+00 alpha(00000190)=0.000000000000000E+00 beta (00000191)=0.128651907089398E+02 gamma(00000191)=0.128651907089398E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 191 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000191)=0.000000000000000E+00 beta (00000192)=0.134373743593997E+02 gamma(00000192)=0.134373743593997E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 192 z1= 1 -.105886825545751E-05 0.000000000000000E+00 z1= 2 -.143886348858214E-02 0.000000000000000E+00 z1= 3 -.121411707353785E-05 0.000000000000000E+00 alpha(00000192)=0.000000000000000E+00 beta (00000193)=0.127839054630780E+02 gamma(00000193)=0.127839054630780E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 193 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000193)=0.000000000000000E+00 beta (00000194)=0.131981222093619E+02 gamma(00000194)=0.131981222093619E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 194 z1= 1 0.105305425094444E-05 0.000000000000000E+00 z1= 2 0.131549665139537E-02 0.000000000000000E+00 z1= 3 0.127175235195348E-05 0.000000000000000E+00 alpha(00000194)=0.000000000000000E+00 beta (00000195)=0.126839715566835E+02 gamma(00000195)=0.126839715566835E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 195 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000195)=0.000000000000000E+00 beta (00000196)=0.133139850083846E+02 gamma(00000196)=0.133139850083846E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 196 z1= 1 -.102930308852741E-05 0.000000000000000E+00 z1= 2 -.121596013638692E-02 0.000000000000000E+00 z1= 3 -.131999883206248E-05 0.000000000000000E+00 alpha(00000196)=0.000000000000000E+00 beta (00000197)=0.126079514649386E+02 gamma(00000197)=0.126079514649386E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 197 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000197)=0.000000000000000E+00 beta (00000198)=0.136343173950944E+02 gamma(00000198)=0.136343173950944E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 198 z1= 1 0.981642291674432E-06 0.000000000000000E+00 z1= 2 0.114358291716641E-02 0.000000000000000E+00 z1= 3 0.131332220974995E-05 0.000000000000000E+00 alpha(00000198)=0.000000000000000E+00 beta (00000199)=0.126706235348146E+02 gamma(00000199)=0.126706235348146E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 199 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000199)=0.000000000000000E+00 beta (00000200)=0.134978599498391E+02 gamma(00000200)=0.134978599498391E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 200 z1= 1 -.955347674870414E-06 0.000000000000000E+00 z1= 2 -.113916140398469E-02 0.000000000000000E+00 z1= 3 -.133730305478007E-05 0.000000000000000E+00 alpha(00000200)=0.000000000000000E+00 beta (00000201)=0.126143087869868E+02 gamma(00000201)=0.126143087869868E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 201 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000201)=0.000000000000000E+00 beta (00000202)=0.133826767928539E+02 gamma(00000202)=0.133826767928539E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 202 z1= 1 0.927116197872897E-06 0.000000000000000E+00 z1= 2 0.113989695775037E-02 0.000000000000000E+00 z1= 3 0.133624008330296E-05 0.000000000000000E+00 alpha(00000202)=0.000000000000000E+00 beta (00000203)=0.127737830500156E+02 gamma(00000203)=0.127737830500156E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 203 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000203)=0.000000000000000E+00 beta (00000204)=0.135575572400017E+02 gamma(00000204)=0.135575572400017E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 204 z1= 1 -.896363712115343E-06 0.000000000000000E+00 z1= 2 -.112066319849019E-02 0.000000000000000E+00 z1= 3 -.134432142647400E-05 0.000000000000000E+00 alpha(00000204)=0.000000000000000E+00 beta (00000205)=0.128450529322169E+02 gamma(00000205)=0.128450529322169E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 205 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000205)=0.000000000000000E+00 beta (00000206)=0.134791517419749E+02 gamma(00000206)=0.134791517419749E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 206 z1= 1 0.883322866461348E-06 0.000000000000000E+00 z1= 2 0.117521975788877E-02 0.000000000000000E+00 z1= 3 0.133889799755173E-05 0.000000000000000E+00 alpha(00000206)=0.000000000000000E+00 beta (00000207)=0.127620232765468E+02 gamma(00000207)=0.127620232765468E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 207 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000207)=0.000000000000000E+00 beta (00000208)=0.133839133766670E+02 gamma(00000208)=0.133839133766670E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 208 z1= 1 -.878535337546591E-06 0.000000000000000E+00 z1= 2 -.125146245668752E-02 0.000000000000000E+00 z1= 3 -.133679469833302E-05 0.000000000000000E+00 alpha(00000208)=0.000000000000000E+00 beta (00000209)=0.126288010205754E+02 gamma(00000209)=0.126288010205754E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 209 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000209)=0.000000000000000E+00 beta (00000210)=0.135242396688555E+02 gamma(00000210)=0.135242396688555E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 210 z1= 1 0.873681965328152E-06 0.000000000000000E+00 z1= 2 0.133348372586061E-02 0.000000000000000E+00 z1= 3 0.130806393405496E-05 0.000000000000000E+00 alpha(00000210)=0.000000000000000E+00 beta (00000211)=0.126503349545983E+02 gamma(00000211)=0.126503349545983E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 211 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000211)=0.000000000000000E+00 beta (00000212)=0.135864429532374E+02 gamma(00000212)=0.135864429532374E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 212 z1= 1 -.865499704505706E-06 0.000000000000000E+00 z1= 2 -.134121092682849E-02 0.000000000000000E+00 z1= 3 -.129392508056903E-05 0.000000000000000E+00 alpha(00000212)=0.000000000000000E+00 beta (00000213)=0.126859768542068E+02 gamma(00000213)=0.126859768542068E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 213 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000213)=0.000000000000000E+00 beta (00000214)=0.134727092063749E+02 gamma(00000214)=0.134727092063749E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 214 z1= 1 0.850029226464287E-06 0.000000000000000E+00 z1= 2 0.124209442916493E-02 0.000000000000000E+00 z1= 3 0.130801361068462E-05 0.000000000000000E+00 alpha(00000214)=0.000000000000000E+00 beta (00000215)=0.125567704421397E+02 gamma(00000215)=0.125567704421397E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 215 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000215)=0.000000000000000E+00 beta (00000216)=0.132488421462506E+02 gamma(00000216)=0.132488421462506E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 216 z1= 1 -.851693890188861E-06 0.000000000000000E+00 z1= 2 -.111931306454405E-02 0.000000000000000E+00 z1= 3 -.131337116169493E-05 0.000000000000000E+00 alpha(00000216)=0.000000000000000E+00 beta (00000217)=0.124624319850318E+02 gamma(00000217)=0.124624319850318E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 217 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000217)=0.000000000000000E+00 beta (00000218)=0.136513087968110E+02 gamma(00000218)=0.136513087968110E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 218 z1= 1 0.828443591122628E-06 0.000000000000000E+00 z1= 2 0.927181250573297E-03 0.000000000000000E+00 z1= 3 0.126686686126499E-05 0.000000000000000E+00 alpha(00000218)=0.000000000000000E+00 beta (00000219)=0.127274188956597E+02 gamma(00000219)=0.127274188956597E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 219 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000219)=0.000000000000000E+00 beta (00000220)=0.134287314094792E+02 gamma(00000220)=0.134287314094792E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 220 z1= 1 -.850437689616478E-06 0.000000000000000E+00 z1= 2 -.776987579438799E-03 0.000000000000000E+00 z1= 3 -.126554353487289E-05 0.000000000000000E+00 alpha(00000220)=0.000000000000000E+00 beta (00000221)=0.127703411449233E+02 gamma(00000221)=0.127703411449233E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 221 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000221)=0.000000000000000E+00 beta (00000222)=0.132933884841728E+02 gamma(00000222)=0.132933884841728E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 222 z1= 1 0.872606113910650E-06 0.000000000000000E+00 z1= 2 0.620844232344617E-03 0.000000000000000E+00 z1= 3 0.130815154296470E-05 0.000000000000000E+00 alpha(00000222)=0.000000000000000E+00 beta (00000223)=0.128282686446039E+02 gamma(00000223)=0.128282686446039E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 223 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000223)=0.000000000000000E+00 beta (00000224)=0.132058908487242E+02 gamma(00000224)=0.132058908487242E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 224 z1= 1 -.910036462365912E-06 0.000000000000000E+00 z1= 2 -.430553878533129E-03 0.000000000000000E+00 z1= 3 -.133526239660416E-05 0.000000000000000E+00 alpha(00000224)=0.000000000000000E+00 beta (00000225)=0.129770312977519E+02 gamma(00000225)=0.129770312977519E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 225 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000225)=0.000000000000000E+00 beta (00000226)=0.133541700347540E+02 gamma(00000226)=0.133541700347540E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 226 z1= 1 0.944399509473365E-06 0.000000000000000E+00 z1= 2 0.236409851760667E-03 0.000000000000000E+00 z1= 3 0.137376591355441E-05 0.000000000000000E+00 alpha(00000226)=0.000000000000000E+00 beta (00000227)=0.128225225663633E+02 gamma(00000227)=0.128225225663633E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 227 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000227)=0.000000000000000E+00 beta (00000228)=0.135109060216889E+02 gamma(00000228)=0.135109060216889E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 228 z1= 1 -.953996327546225E-06 0.000000000000000E+00 z1= 2 -.768633584714564E-04 0.000000000000000E+00 z1= 3 -.133799529341186E-05 0.000000000000000E+00 alpha(00000228)=0.000000000000000E+00 beta (00000229)=0.127024334944472E+02 gamma(00000229)=0.127024334944472E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 229 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000229)=0.000000000000000E+00 beta (00000230)=0.134491715501510E+02 gamma(00000230)=0.134491715501510E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 230 z1= 1 0.972377776034539E-06 0.000000000000000E+00 z1= 2 -.455748279973040E-04 0.000000000000000E+00 z1= 3 0.133965330115609E-05 0.000000000000000E+00 alpha(00000230)=0.000000000000000E+00 beta (00000231)=0.129123603371113E+02 gamma(00000231)=0.129123603371113E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 231 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000231)=0.000000000000000E+00 beta (00000232)=0.137268104971942E+02 gamma(00000232)=0.137268104971942E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 232 z1= 1 -.987285613867663E-06 0.000000000000000E+00 z1= 2 0.113504737881565E-03 0.000000000000000E+00 z1= 3 -.130940158504415E-05 0.000000000000000E+00 alpha(00000232)=0.000000000000000E+00 beta (00000233)=0.127781174563640E+02 gamma(00000233)=0.127781174563640E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 233 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000233)=0.000000000000000E+00 beta (00000234)=0.133503612623734E+02 gamma(00000234)=0.133503612623734E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 234 z1= 1 0.100948176495839E-05 0.000000000000000E+00 z1= 2 -.180127206282899E-03 0.000000000000000E+00 z1= 3 0.132116743718742E-05 0.000000000000000E+00 alpha(00000234)=0.000000000000000E+00 beta (00000235)=0.125912024451843E+02 gamma(00000235)=0.125912024451843E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 235 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000235)=0.000000000000000E+00 beta (00000236)=0.133931141622375E+02 gamma(00000236)=0.133931141622375E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 236 z1= 1 -.102199228193406E-05 0.000000000000000E+00 z1= 2 0.213806717262668E-03 0.000000000000000E+00 z1= 3 -.127841568937180E-05 0.000000000000000E+00 alpha(00000236)=0.000000000000000E+00 beta (00000237)=0.128915668099101E+02 gamma(00000237)=0.128915668099101E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 237 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000237)=0.000000000000000E+00 beta (00000238)=0.135197304826154E+02 gamma(00000238)=0.135197304826154E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 238 z1= 1 0.104532951208025E-05 0.000000000000000E+00 z1= 2 -.247530223507467E-03 0.000000000000000E+00 z1= 3 0.127062360820615E-05 0.000000000000000E+00 alpha(00000238)=0.000000000000000E+00 beta (00000239)=0.127636396902612E+02 gamma(00000239)=0.127636396902612E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 239 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000239)=0.000000000000000E+00 beta (00000240)=0.133597409977578E+02 gamma(00000240)=0.133597409977578E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 240 z1= 1 -.108161975349722E-05 0.000000000000000E+00 z1= 2 0.255333974630641E-03 0.000000000000000E+00 z1= 3 -.126380092439678E-05 0.000000000000000E+00 alpha(00000240)=0.000000000000000E+00 beta (00000241)=0.127491178290454E+02 gamma(00000241)=0.127491178290454E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 241 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000241)=0.000000000000000E+00 beta (00000242)=0.134029042455223E+02 gamma(00000242)=0.134029042455223E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 242 z1= 1 0.110527521734105E-05 0.000000000000000E+00 z1= 2 -.217567045153732E-03 0.000000000000000E+00 z1= 3 0.125295766502956E-05 0.000000000000000E+00 alpha(00000242)=0.000000000000000E+00 beta (00000243)=0.128892946334448E+02 gamma(00000243)=0.128892946334448E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 243 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000243)=0.000000000000000E+00 beta (00000244)=0.135139866616815E+02 gamma(00000244)=0.135139866616815E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 244 z1= 1 -.113487958593346E-05 0.000000000000000E+00 z1= 2 0.176696891781706E-03 0.000000000000000E+00 z1= 3 -.123572124250320E-05 0.000000000000000E+00 alpha(00000244)=0.000000000000000E+00 beta (00000245)=0.125465536733505E+02 gamma(00000245)=0.125465536733505E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 245 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000245)=0.000000000000000E+00 beta (00000246)=0.130511079468503E+02 gamma(00000246)=0.130511079468503E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 246 z1= 1 0.118721851062684E-05 0.000000000000000E+00 z1= 2 -.687408421305370E-04 0.000000000000000E+00 z1= 3 0.124278943569936E-05 0.000000000000000E+00 alpha(00000246)=0.000000000000000E+00 beta (00000247)=0.125672198386659E+02 gamma(00000247)=0.125672198386659E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 247 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000247)=0.000000000000000E+00 beta (00000248)=0.133322035592173E+02 gamma(00000248)=0.133322035592173E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 248 z1= 1 -.121480099398059E-05 0.000000000000000E+00 z1= 2 -.265981713172530E-04 0.000000000000000E+00 z1= 3 -.123385205859857E-05 0.000000000000000E+00 alpha(00000248)=0.000000000000000E+00 beta (00000249)=0.127880922753763E+02 gamma(00000249)=0.127880922753763E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 249 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000249)=0.000000000000000E+00 beta (00000250)=0.134565568619762E+02 gamma(00000250)=0.134565568619762E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 250 z1= 1 0.126107430284883E-05 0.000000000000000E+00 z1= 2 0.128723668995353E-03 0.000000000000000E+00 z1= 3 0.122027158859712E-05 0.000000000000000E+00 alpha(00000250)=0.000000000000000E+00 beta (00000251)=0.125503639309223E+02 gamma(00000251)=0.125503639309223E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 251 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000251)=0.000000000000000E+00 beta (00000252)=0.132840536605146E+02 gamma(00000252)=0.132840536605146E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 252 z1= 1 -.129200003281269E-05 0.000000000000000E+00 z1= 2 -.179188200957442E-03 0.000000000000000E+00 z1= 3 -.121041605506209E-05 0.000000000000000E+00 alpha(00000252)=0.000000000000000E+00 beta (00000253)=0.129336423167541E+02 gamma(00000253)=0.129336423167541E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 253 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000253)=0.000000000000000E+00 beta (00000254)=0.135149120536037E+02 gamma(00000254)=0.135149120536037E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 254 z1= 1 0.133250890047357E-05 0.000000000000000E+00 z1= 2 0.150891868853606E-03 0.000000000000000E+00 z1= 3 0.120199219873041E-05 0.000000000000000E+00 alpha(00000254)=0.000000000000000E+00 beta (00000255)=0.128019307932415E+02 gamma(00000255)=0.128019307932415E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 255 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000255)=0.000000000000000E+00 beta (00000256)=0.136716697142721E+02 gamma(00000256)=0.136716697142721E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 256 z1= 1 -.132757292687757E-05 0.000000000000000E+00 z1= 2 -.136956715164454E-03 0.000000000000000E+00 z1= 3 -.118568979223982E-05 0.000000000000000E+00 alpha(00000256)=0.000000000000000E+00 beta (00000257)=0.128300179995846E+02 gamma(00000257)=0.128300179995846E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 257 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000257)=0.000000000000000E+00 beta (00000258)=0.134221774427154E+02 gamma(00000258)=0.134221774427154E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 258 z1= 1 0.134506323670215E-05 0.000000000000000E+00 z1= 2 0.138198170213344E-03 0.000000000000000E+00 z1= 3 0.117713097896936E-05 0.000000000000000E+00 alpha(00000258)=0.000000000000000E+00 beta (00000259)=0.130324445508445E+02 gamma(00000259)=0.130324445508445E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 259 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000259)=0.000000000000000E+00 beta (00000260)=0.135340607670088E+02 gamma(00000260)=0.135340607670088E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 260 z1= 1 -.136541362963892E-05 0.000000000000000E+00 z1= 2 -.927659958290012E-04 0.000000000000000E+00 z1= 3 -.117533193323336E-05 0.000000000000000E+00 alpha(00000260)=0.000000000000000E+00 beta (00000261)=0.127717086264339E+02 gamma(00000261)=0.127717086264339E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 261 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000261)=0.000000000000000E+00 beta (00000262)=0.133221274138509E+02 gamma(00000262)=0.133221274138509E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 262 z1= 1 0.139452693070224E-05 0.000000000000000E+00 z1= 2 0.478562283870339E-04 0.000000000000000E+00 z1= 3 0.114098830172424E-05 0.000000000000000E+00 alpha(00000262)=0.000000000000000E+00 beta (00000263)=0.126369388269677E+02 gamma(00000263)=0.126369388269677E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 263 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000263)=0.000000000000000E+00 beta (00000264)=0.132587154934946E+02 gamma(00000264)=0.132587154934946E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 264 z1= 1 -.141372522817138E-05 0.000000000000000E+00 z1= 2 -.453434143991589E-05 0.000000000000000E+00 z1= 3 -.111464317330547E-05 0.000000000000000E+00 alpha(00000264)=0.000000000000000E+00 beta (00000265)=0.127327472975876E+02 gamma(00000265)=0.127327472975876E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 265 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000265)=0.000000000000000E+00 beta (00000266)=0.134480098373093E+02 gamma(00000266)=0.134480098373093E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 266 z1= 1 0.143363440780787E-05 0.000000000000000E+00 z1= 2 0.646035586818325E-05 0.000000000000000E+00 z1= 3 0.107596559581587E-05 0.000000000000000E+00 alpha(00000266)=0.000000000000000E+00 beta (00000267)=0.127991051512289E+02 gamma(00000267)=0.127991051512289E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 267 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000267)=0.000000000000000E+00 beta (00000268)=0.133509673563405E+02 gamma(00000268)=0.133509673563405E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 268 z1= 1 -.147477075616853E-05 0.000000000000000E+00 z1= 2 -.567036348870821E-04 0.000000000000000E+00 z1= 3 -.105059387456359E-05 0.000000000000000E+00 alpha(00000268)=0.000000000000000E+00 beta (00000269)=0.126159938745077E+02 gamma(00000269)=0.126159938745077E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 269 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000269)=0.000000000000000E+00 beta (00000270)=0.135207226860741E+02 gamma(00000270)=0.135207226860741E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 270 z1= 1 0.147446732578875E-05 0.000000000000000E+00 z1= 2 0.127098384020150E-03 0.000000000000000E+00 z1= 3 0.978920613154729E-06 0.000000000000000E+00 alpha(00000270)=0.000000000000000E+00 beta (00000271)=0.130324169214886E+02 gamma(00000271)=0.130324169214886E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 271 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000271)=0.000000000000000E+00 beta (00000272)=0.132956033037527E+02 gamma(00000272)=0.132956033037527E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 272 z1= 1 -.155406102009779E-05 0.000000000000000E+00 z1= 2 -.191682755721671E-03 0.000000000000000E+00 z1= 3 -.965263491526465E-06 0.000000000000000E+00 alpha(00000272)=0.000000000000000E+00 beta (00000273)=0.127269485223252E+02 gamma(00000273)=0.127269485223252E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 273 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000273)=0.000000000000000E+00 beta (00000274)=0.134985187746427E+02 gamma(00000274)=0.134985187746427E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 274 z1= 1 0.157806974653008E-05 0.000000000000000E+00 z1= 2 0.170281401654718E-03 0.000000000000000E+00 z1= 3 0.892795715572213E-06 0.000000000000000E+00 alpha(00000274)=0.000000000000000E+00 beta (00000275)=0.128622195341415E+02 gamma(00000275)=0.128622195341415E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 275 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000275)=0.000000000000000E+00 beta (00000276)=0.137440404561413E+02 gamma(00000276)=0.137440404561413E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 276 z1= 1 -.157822361084373E-05 0.000000000000000E+00 z1= 2 -.142696395629180E-03 0.000000000000000E+00 z1= 3 -.823101514791150E-06 0.000000000000000E+00 alpha(00000276)=0.000000000000000E+00 beta (00000277)=0.127464610376212E+02 gamma(00000277)=0.127464610376212E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 277 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000277)=0.000000000000000E+00 beta (00000278)=0.131863605069894E+02 gamma(00000278)=0.131863605069894E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 278 z1= 1 0.163462003272691E-05 0.000000000000000E+00 z1= 2 0.109513420053133E-03 0.000000000000000E+00 z1= 3 0.771098534453542E-06 0.000000000000000E+00 alpha(00000278)=0.000000000000000E+00 beta (00000279)=0.125348490709038E+02 gamma(00000279)=0.125348490709038E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 279 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000279)=0.000000000000000E+00 beta (00000280)=0.133613109230864E+02 gamma(00000280)=0.133613109230864E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 280 z1= 1 -.163670117016637E-05 0.000000000000000E+00 z1= 2 -.759403689261102E-04 0.000000000000000E+00 z1= 3 -.703836548087051E-06 0.000000000000000E+00 alpha(00000280)=0.000000000000000E+00 beta (00000281)=0.128734600323008E+02 gamma(00000281)=0.128734600323008E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 281 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000281)=0.000000000000000E+00 beta (00000282)=0.132961402939048E+02 gamma(00000282)=0.132961402939048E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 282 z1= 1 0.168079154288202E-05 0.000000000000000E+00 z1= 2 0.275906530979196E-04 0.000000000000000E+00 z1= 3 0.647156618064975E-06 0.000000000000000E+00 alpha(00000282)=0.000000000000000E+00 beta (00000283)=0.125942929899832E+02 gamma(00000283)=0.125942929899832E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 283 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000283)=0.000000000000000E+00 beta (00000284)=0.132143407751469E+02 gamma(00000284)=0.132143407751469E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 284 z1= 1 -.169448906673329E-05 0.000000000000000E+00 z1= 2 0.583852729084218E-04 0.000000000000000E+00 z1= 3 -.574042646509139E-06 0.000000000000000E+00 alpha(00000284)=0.000000000000000E+00 beta (00000285)=0.126628073134760E+02 gamma(00000285)=0.126628073134760E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 285 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000285)=0.000000000000000E+00 beta (00000286)=0.134122137893592E+02 gamma(00000286)=0.134122137893592E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 286 z1= 1 0.168271216367116E-05 0.000000000000000E+00 z1= 2 -.190995220040017E-03 0.000000000000000E+00 z1= 3 0.504200556868388E-06 0.000000000000000E+00 alpha(00000286)=0.000000000000000E+00 beta (00000287)=0.126240008132624E+02 gamma(00000287)=0.126240008132624E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 287 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000287)=0.000000000000000E+00 beta (00000288)=0.130876656076923E+02 gamma(00000288)=0.130876656076923E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 288 z1= 1 -.171015535151055E-05 0.000000000000000E+00 z1= 2 0.349756716119525E-03 0.000000000000000E+00 z1= 3 -.414278006011671E-06 0.000000000000000E+00 alpha(00000288)=0.000000000000000E+00 beta (00000289)=0.127646911703897E+02 gamma(00000289)=0.127646911703897E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 289 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000289)=0.000000000000000E+00 beta (00000290)=0.134266750564664E+02 gamma(00000290)=0.134266750564664E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 290 z1= 1 0.170229660603587E-05 0.000000000000000E+00 z1= 2 -.501289372105538E-03 0.000000000000000E+00 z1= 3 0.344846806925791E-06 0.000000000000000E+00 alpha(00000290)=0.000000000000000E+00 beta (00000291)=0.127607117392204E+02 gamma(00000291)=0.127607117392204E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 291 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000291)=0.000000000000000E+00 beta (00000292)=0.131977186799303E+02 gamma(00000292)=0.131977186799303E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 292 z1= 1 -.172943583259203E-05 0.000000000000000E+00 z1= 2 0.625416105519390E-03 0.000000000000000E+00 z1= 3 -.251729362575891E-06 0.000000000000000E+00 alpha(00000292)=0.000000000000000E+00 beta (00000293)=0.126412198962739E+02 gamma(00000293)=0.126412198962739E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 293 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000293)=0.000000000000000E+00 beta (00000294)=0.135269357693572E+02 gamma(00000294)=0.135269357693572E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 294 z1= 1 0.167999638988735E-05 0.000000000000000E+00 z1= 2 -.725936229533813E-03 0.000000000000000E+00 z1= 3 0.198791221524877E-06 0.000000000000000E+00 alpha(00000294)=0.000000000000000E+00 beta (00000295)=0.129785112100049E+02 gamma(00000295)=0.129785112100049E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 295 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000295)=0.000000000000000E+00 beta (00000296)=0.135622829076972E+02 gamma(00000296)=0.135622829076972E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 296 z1= 1 -.168504424678893E-05 0.000000000000000E+00 z1= 2 0.768704596292417E-03 0.000000000000000E+00 z1= 3 -.129597021937230E-06 0.000000000000000E+00 alpha(00000296)=0.000000000000000E+00 beta (00000297)=0.127907392600332E+02 gamma(00000297)=0.127907392600332E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 297 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000297)=0.000000000000000E+00 beta (00000298)=0.133436976241761E+02 gamma(00000298)=0.133436976241761E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 298 z1= 1 0.167961549451656E-05 0.000000000000000E+00 z1= 2 -.707544265171190E-03 0.000000000000000E+00 z1= 3 0.910713718204779E-07 0.000000000000000E+00 alpha(00000298)=0.000000000000000E+00 beta (00000299)=0.130107145637696E+02 gamma(00000299)=0.130107145637696E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 299 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000299)=0.000000000000000E+00 beta (00000300)=0.136889156185896E+02 gamma(00000300)=0.136889156185896E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 300 z1= 1 -.167450681560696E-05 0.000000000000000E+00 z1= 2 0.684645446394782E-03 0.000000000000000E+00 z1= 3 -.325547169062685E-07 0.000000000000000E+00 alpha(00000300)=0.000000000000000E+00 beta (00000301)=0.127325773352904E+02 gamma(00000301)=0.127325773352904E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 301 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000301)=0.000000000000000E+00 beta (00000302)=0.132014487848504E+02 gamma(00000302)=0.132014487848504E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 302 z1= 1 0.168245889043111E-05 0.000000000000000E+00 z1= 2 -.647272898753966E-03 0.000000000000000E+00 z1= 3 0.755107433796521E-08 0.000000000000000E+00 alpha(00000302)=0.000000000000000E+00 beta (00000303)=0.127870309133300E+02 gamma(00000303)=0.127870309133300E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 303 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000303)=0.000000000000000E+00 beta (00000304)=0.135647531490717E+02 gamma(00000304)=0.135647531490717E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 304 z1= 1 -.166716901492522E-05 0.000000000000000E+00 z1= 2 0.551175315352377E-03 0.000000000000000E+00 z1= 3 0.176471976389564E-07 0.000000000000000E+00 alpha(00000304)=0.000000000000000E+00 beta (00000305)=0.128308750491585E+02 gamma(00000305)=0.128308750491585E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 305 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000305)=0.000000000000000E+00 beta (00000306)=0.134495308588633E+02 gamma(00000306)=0.134495308588633E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 306 z1= 1 0.167531826631134E-05 0.000000000000000E+00 z1= 2 -.426463914298500E-03 0.000000000000000E+00 z1= 3 -.394053602761793E-07 0.000000000000000E+00 alpha(00000306)=0.000000000000000E+00 beta (00000307)=0.127987513860681E+02 gamma(00000307)=0.127987513860681E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 307 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000307)=0.000000000000000E+00 beta (00000308)=0.135696261752637E+02 gamma(00000308)=0.135696261752637E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 308 z1= 1 -.166929078432212E-05 0.000000000000000E+00 z1= 2 0.239660955568350E-03 0.000000000000000E+00 z1= 3 0.675470303518680E-07 0.000000000000000E+00 alpha(00000308)=0.000000000000000E+00 beta (00000309)=0.127885413404553E+02 gamma(00000309)=0.127885413404553E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 309 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000309)=0.000000000000000E+00 beta (00000310)=0.133077694844220E+02 gamma(00000310)=0.133077694844220E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 310 z1= 1 0.168443650944584E-05 0.000000000000000E+00 z1= 2 -.705070220550124E-04 0.000000000000000E+00 z1= 3 -.111919997692733E-06 0.000000000000000E+00 alpha(00000310)=0.000000000000000E+00 beta (00000311)=0.127286681926412E+02 gamma(00000311)=0.127286681926412E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 311 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000311)=0.000000000000000E+00 beta (00000312)=0.134430681708486E+02 gamma(00000312)=0.134430681708486E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 312 z1= 1 -.168672394563031E-05 0.000000000000000E+00 z1= 2 -.739757141366730E-04 0.000000000000000E+00 z1= 3 0.136203964960129E-06 0.000000000000000E+00 alpha(00000312)=0.000000000000000E+00 beta (00000313)=0.128578436259766E+02 gamma(00000313)=0.128578436259766E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 313 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000313)=0.000000000000000E+00 beta (00000314)=0.132261688765880E+02 gamma(00000314)=0.132261688765880E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 314 z1= 1 0.174613556417377E-05 0.000000000000000E+00 z1= 2 0.259139317874287E-03 0.000000000000000E+00 z1= 3 -.152148177303443E-06 0.000000000000000E+00 alpha(00000314)=0.000000000000000E+00 beta (00000315)=0.124474649642795E+02 gamma(00000315)=0.124474649642795E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 315 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000315)=0.000000000000000E+00 beta (00000316)=0.134572311191633E+02 gamma(00000316)=0.134572311191633E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 316 z1= 1 -.172060932114603E-05 0.000000000000000E+00 z1= 2 -.404046364644721E-03 0.000000000000000E+00 z1= 3 0.114035490731725E-06 0.000000000000000E+00 alpha(00000316)=0.000000000000000E+00 beta (00000317)=0.125627924292246E+02 gamma(00000317)=0.125627924292246E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 317 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000317)=0.000000000000000E+00 beta (00000318)=0.134454999593869E+02 gamma(00000318)=0.134454999593869E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 318 z1= 1 0.171096878992354E-05 0.000000000000000E+00 z1= 2 0.507490277590244E-03 0.000000000000000E+00 z1= 3 -.121091880290764E-06 0.000000000000000E+00 alpha(00000318)=0.000000000000000E+00 beta (00000319)=0.125691258390293E+02 gamma(00000319)=0.125691258390293E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 319 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000319)=0.000000000000000E+00 beta (00000320)=0.132683743555628E+02 gamma(00000320)=0.132683743555628E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 320 z1= 1 -.173510962716682E-05 0.000000000000000E+00 z1= 2 -.613741246854104E-03 0.000000000000000E+00 z1= 3 0.824301510115883E-07 0.000000000000000E+00 alpha(00000320)=0.000000000000000E+00 beta (00000321)=0.128768098339927E+02 gamma(00000321)=0.128768098339927E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 321 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000321)=0.000000000000000E+00 beta (00000322)=0.135396602572877E+02 gamma(00000322)=0.135396602572877E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 322 z1= 1 0.178309204377277E-05 0.000000000000000E+00 z1= 2 0.611567668819772E-03 0.000000000000000E+00 z1= 3 -.682260537335526E-07 0.000000000000000E+00 alpha(00000322)=0.000000000000000E+00 beta (00000323)=0.127480241353615E+02 gamma(00000323)=0.127480241353615E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 323 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000323)=0.000000000000000E+00 beta (00000324)=0.132686652253103E+02 gamma(00000324)=0.132686652253103E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 324 z1= 1 -.183059107428194E-05 0.000000000000000E+00 z1= 2 -.593337003143229E-03 0.000000000000000E+00 z1= 3 0.229762592052793E-07 0.000000000000000E+00 alpha(00000324)=0.000000000000000E+00 beta (00000325)=0.127942827515080E+02 gamma(00000325)=0.127942827515080E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 325 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000325)=0.000000000000000E+00 beta (00000326)=0.137027001426078E+02 gamma(00000326)=0.137027001426078E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 326 z1= 1 0.183481642014680E-05 0.000000000000000E+00 z1= 2 0.515227588434150E-03 0.000000000000000E+00 z1= 3 -.421668392662088E-07 0.000000000000000E+00 alpha(00000326)=0.000000000000000E+00 beta (00000327)=0.126562924908262E+02 gamma(00000327)=0.126562924908262E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 327 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000327)=0.000000000000000E+00 beta (00000328)=0.132710951464007E+02 gamma(00000328)=0.132710951464007E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 328 z1= 1 -.186609580259556E-05 0.000000000000000E+00 z1= 2 -.372280021037917E-03 0.000000000000000E+00 z1= 3 0.788269774215818E-09 0.000000000000000E+00 alpha(00000328)=0.000000000000000E+00 beta (00000329)=0.128093971320915E+02 gamma(00000329)=0.128093971320915E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 329 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000329)=0.000000000000000E+00 beta (00000330)=0.136222209864970E+02 gamma(00000330)=0.136222209864970E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 330 z1= 1 0.188768260157802E-05 0.000000000000000E+00 z1= 2 0.204261523050335E-03 0.000000000000000E+00 z1= 3 -.616045428256421E-08 0.000000000000000E+00 alpha(00000330)=0.000000000000000E+00 beta (00000331)=0.126670241263200E+02 gamma(00000331)=0.126670241263200E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 331 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000331)=0.000000000000000E+00 beta (00000332)=0.133665205684371E+02 gamma(00000332)=0.133665205684371E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 332 z1= 1 -.191076385247686E-05 0.000000000000000E+00 z1= 2 0.521321095403419E-05 0.000000000000000E+00 z1= 3 -.369587469134817E-07 0.000000000000000E+00 alpha(00000332)=0.000000000000000E+00 beta (00000333)=0.128362196975157E+02 gamma(00000333)=0.128362196975157E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 333 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000333)=0.000000000000000E+00 beta (00000334)=0.134610345081187E+02 gamma(00000334)=0.134610345081187E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 334 z1= 1 0.196740617152118E-05 0.000000000000000E+00 z1= 2 -.149667990688938E-03 0.000000000000000E+00 z1= 3 0.390289648726460E-07 0.000000000000000E+00 alpha(00000334)=0.000000000000000E+00 beta (00000335)=0.124678181602357E+02 gamma(00000335)=0.124678181602357E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 335 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000335)=0.000000000000000E+00 beta (00000336)=0.130935907161810E+02 gamma(00000336)=0.130935907161810E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 336 z1= 1 -.201214556908979E-05 0.000000000000000E+00 z1= 2 0.268242964186641E-03 0.000000000000000E+00 z1= 3 -.107704328202563E-06 0.000000000000000E+00 alpha(00000336)=0.000000000000000E+00 beta (00000337)=0.129076750594721E+02 gamma(00000337)=0.129076750594721E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 337 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000337)=0.000000000000000E+00 beta (00000338)=0.135012873479254E+02 gamma(00000338)=0.135012873479254E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 338 z1= 1 0.207656199710006E-05 0.000000000000000E+00 z1= 2 -.430242704326196E-03 0.000000000000000E+00 z1= 3 0.125180376712715E-06 0.000000000000000E+00 alpha(00000338)=0.000000000000000E+00 beta (00000339)=0.126384590763615E+02 gamma(00000339)=0.126384590763615E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 339 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000339)=0.000000000000000E+00 beta (00000340)=0.132422079861262E+02 gamma(00000340)=0.132422079861262E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 340 z1= 1 -.212818595083427E-05 0.000000000000000E+00 z1= 2 0.595769954586347E-03 0.000000000000000E+00 z1= 3 -.184999855043348E-06 0.000000000000000E+00 alpha(00000340)=0.000000000000000E+00 beta (00000341)=0.126707129061398E+02 gamma(00000341)=0.126707129061398E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 341 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000341)=0.000000000000000E+00 beta (00000342)=0.136753605969909E+02 gamma(00000342)=0.136753605969909E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 342 z1= 1 0.211864933039301E-05 0.000000000000000E+00 z1= 2 -.712254604936116E-03 0.000000000000000E+00 z1= 3 0.178232005117765E-06 0.000000000000000E+00 alpha(00000342)=0.000000000000000E+00 beta (00000343)=0.127943552503819E+02 gamma(00000343)=0.127943552503819E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 343 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000343)=0.000000000000000E+00 beta (00000344)=0.135431231585370E+02 gamma(00000344)=0.135431231585370E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 344 z1= 1 -.212355215422049E-05 0.000000000000000E+00 z1= 2 0.857918071920317E-03 0.000000000000000E+00 z1= 3 -.216152375186293E-06 0.000000000000000E+00 alpha(00000344)=0.000000000000000E+00 beta (00000345)=0.129527963646180E+02 gamma(00000345)=0.129527963646180E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 345 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000345)=0.000000000000000E+00 beta (00000346)=0.134551263461387E+02 gamma(00000346)=0.134551263461387E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 346 z1= 1 0.220132946146534E-05 0.000000000000000E+00 z1= 2 -.104511270130339E-02 0.000000000000000E+00 z1= 3 0.223251783271845E-06 0.000000000000000E+00 alpha(00000346)=0.000000000000000E+00 beta (00000347)=0.125651941790397E+02 gamma(00000347)=0.125651941790397E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 347 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000347)=0.000000000000000E+00 beta (00000348)=0.134783867418469E+02 gamma(00000348)=0.134783867418469E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 348 z1= 1 -.219130057782860E-05 0.000000000000000E+00 z1= 2 0.116944914391981E-02 0.000000000000000E+00 z1= 3 -.258590269266675E-06 0.000000000000000E+00 alpha(00000348)=0.000000000000000E+00 beta (00000349)=0.129739928957293E+02 gamma(00000349)=0.129739928957293E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 349 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000349)=0.000000000000000E+00 beta (00000350)=0.134297684082514E+02 gamma(00000350)=0.134297684082514E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 350 z1= 1 0.225622133388781E-05 0.000000000000000E+00 z1= 2 -.135349710401532E-02 0.000000000000000E+00 z1= 3 0.256690869032900E-06 0.000000000000000E+00 alpha(00000350)=0.000000000000000E+00 beta (00000351)=0.125508355125286E+02 gamma(00000351)=0.125508355125286E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 351 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000351)=0.000000000000000E+00 beta (00000352)=0.134338435878174E+02 gamma(00000352)=0.134338435878174E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 352 z1= 1 -.223607626077989E-05 0.000000000000000E+00 z1= 2 0.143555684430277E-02 0.000000000000000E+00 z1= 3 -.266258456721100E-06 0.000000000000000E+00 alpha(00000352)=0.000000000000000E+00 beta (00000353)=0.129530910448955E+02 gamma(00000353)=0.129530910448955E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 353 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000353)=0.000000000000000E+00 beta (00000354)=0.132873602007166E+02 gamma(00000354)=0.132873602007166E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 354 z1= 1 0.233853340717016E-05 0.000000000000000E+00 z1= 2 -.157566180946363E-02 0.000000000000000E+00 z1= 3 0.265867415534093E-06 0.000000000000000E+00 alpha(00000354)=0.000000000000000E+00 beta (00000355)=0.124749176641733E+02 gamma(00000355)=0.124749176641733E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 355 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000355)=0.000000000000000E+00 beta (00000356)=0.136129860611111E+02 gamma(00000356)=0.136129860611111E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 356 z1= 1 -.227876627792445E-05 0.000000000000000E+00 z1= 2 0.166796377892423E-02 0.000000000000000E+00 z1= 3 -.263219235247382E-06 0.000000000000000E+00 alpha(00000356)=0.000000000000000E+00 beta (00000357)=0.128740530104588E+02 gamma(00000357)=0.128740530104588E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 357 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000357)=0.000000000000000E+00 beta (00000358)=0.136854147256959E+02 gamma(00000358)=0.136854147256959E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 358 z1= 1 0.230670364926612E-05 0.000000000000000E+00 z1= 2 -.178720334654294E-02 0.000000000000000E+00 z1= 3 0.261888233401669E-06 0.000000000000000E+00 alpha(00000358)=0.000000000000000E+00 beta (00000359)=0.126594224871377E+02 gamma(00000359)=0.126594224871377E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 359 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000359)=0.000000000000000E+00 beta (00000360)=0.138515722109383E+02 gamma(00000360)=0.138515722109383E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 360 z1= 1 -.227569845869750E-05 0.000000000000000E+00 z1= 2 0.183607400319989E-02 0.000000000000000E+00 z1= 3 -.248016316406154E-06 0.000000000000000E+00 alpha(00000360)=0.000000000000000E+00 beta (00000361)=0.124128294396756E+02 gamma(00000361)=0.124128294396756E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 361 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000361)=0.000000000000000E+00 beta (00000362)=0.134327987811526E+02 gamma(00000362)=0.134327987811526E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 362 z1= 1 0.230707949244301E-05 0.000000000000000E+00 z1= 2 -.191584878387537E-02 0.000000000000000E+00 z1= 3 0.262247996275552E-06 0.000000000000000E+00 alpha(00000362)=0.000000000000000E+00 beta (00000363)=0.128797661687270E+02 gamma(00000363)=0.128797661687270E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 363 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000363)=0.000000000000000E+00 beta (00000364)=0.135103422048673E+02 gamma(00000364)=0.135103422048673E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 364 z1= 1 -.240656608974273E-05 0.000000000000000E+00 z1= 2 0.201944678404543E-02 0.000000000000000E+00 z1= 3 -.247077090699384E-06 0.000000000000000E+00 alpha(00000364)=0.000000000000000E+00 beta (00000365)=0.122994636981778E+02 gamma(00000365)=0.122994636981778E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 365 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000365)=0.000000000000000E+00 beta (00000366)=0.129062913945586E+02 gamma(00000366)=0.129062913945586E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 366 z1= 1 0.252453145578937E-05 0.000000000000000E+00 z1= 2 -.211652331959299E-02 0.000000000000000E+00 z1= 3 0.272786362234226E-06 0.000000000000000E+00 alpha(00000366)=0.000000000000000E+00 beta (00000367)=0.127034680757071E+02 gamma(00000367)=0.127034680757071E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 367 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000367)=0.000000000000000E+00 beta (00000368)=0.134767166076625E+02 gamma(00000368)=0.134767166076625E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 368 z1= 1 -.259678725443840E-05 0.000000000000000E+00 z1= 2 0.215018172107982E-02 0.000000000000000E+00 z1= 3 -.231482439604547E-06 0.000000000000000E+00 alpha(00000368)=0.000000000000000E+00 beta (00000369)=0.125626721130143E+02 gamma(00000369)=0.125626721130143E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 369 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000369)=0.000000000000000E+00 beta (00000370)=0.133692926302659E+02 gamma(00000370)=0.133692926302659E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 370 z1= 1 0.264599542601322E-05 0.000000000000000E+00 z1= 2 -.212542108382922E-02 0.000000000000000E+00 z1= 3 0.249756781202772E-06 0.000000000000000E+00 alpha(00000370)=0.000000000000000E+00 beta (00000371)=0.128827401390957E+02 gamma(00000371)=0.128827401390957E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 371 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000371)=0.000000000000000E+00 beta (00000372)=0.133106920710818E+02 gamma(00000372)=0.133106920710818E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 372 z1= 1 -.278183490293529E-05 0.000000000000000E+00 z1= 2 0.214723595642328E-02 0.000000000000000E+00 z1= 3 -.187988392705263E-06 0.000000000000000E+00 alpha(00000372)=0.000000000000000E+00 beta (00000373)=0.128999364065571E+02 gamma(00000373)=0.128999364065571E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 373 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000373)=0.000000000000000E+00 beta (00000374)=0.136448690011519E+02 gamma(00000374)=0.136448690011519E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 374 z1= 1 0.283231471173272E-05 0.000000000000000E+00 z1= 2 -.207157533018765E-02 0.000000000000000E+00 z1= 3 0.217953873970101E-06 0.000000000000000E+00 alpha(00000374)=0.000000000000000E+00 beta (00000375)=0.128456592932389E+02 gamma(00000375)=0.128456592932389E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 375 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000375)=0.000000000000000E+00 beta (00000376)=0.131827349382898E+02 gamma(00000376)=0.131827349382898E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 376 z1= 1 -.299477888095201E-05 0.000000000000000E+00 z1= 2 0.196862133418563E-02 0.000000000000000E+00 z1= 3 -.143923398642030E-06 0.000000000000000E+00 alpha(00000376)=0.000000000000000E+00 beta (00000377)=0.130315379073753E+02 gamma(00000377)=0.130315379073753E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 377 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000377)=0.000000000000000E+00 beta (00000378)=0.135748797619598E+02 gamma(00000378)=0.135748797619598E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 378 z1= 1 0.308435105055710E-05 0.000000000000000E+00 z1= 2 -.176136379800871E-02 0.000000000000000E+00 z1= 3 0.184557142534660E-06 0.000000000000000E+00 alpha(00000378)=0.000000000000000E+00 beta (00000379)=0.125824290799668E+02 gamma(00000379)=0.125824290799668E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 379 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000379)=0.000000000000000E+00 beta (00000380)=0.133817908930390E+02 gamma(00000380)=0.133817908930390E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 380 z1= 1 -.315389547578216E-05 0.000000000000000E+00 z1= 2 0.147095341701263E-02 0.000000000000000E+00 z1= 3 -.101796245320266E-06 0.000000000000000E+00 alpha(00000380)=0.000000000000000E+00 beta (00000381)=0.131035175968836E+02 gamma(00000381)=0.131035175968836E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 381 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000381)=0.000000000000000E+00 beta (00000382)=0.134408300255023E+02 gamma(00000382)=0.134408300255023E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 382 z1= 1 0.328100634311695E-05 0.000000000000000E+00 z1= 2 -.127880371272743E-02 0.000000000000000E+00 z1= 3 0.112586862683695E-06 0.000000000000000E+00 alpha(00000382)=0.000000000000000E+00 beta (00000383)=0.129349610668463E+02 gamma(00000383)=0.129349610668463E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 383 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000383)=0.000000000000000E+00 beta (00000384)=0.134943500523714E+02 gamma(00000384)=0.134943500523714E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 384 z1= 1 -.337803690248287E-05 0.000000000000000E+00 z1= 2 0.111249936514956E-02 0.000000000000000E+00 z1= 3 -.229893305132313E-07 0.000000000000000E+00 alpha(00000384)=0.000000000000000E+00 beta (00000385)=0.126533026813928E+02 gamma(00000385)=0.126533026813928E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 385 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000385)=0.000000000000000E+00 beta (00000386)=0.130168904233344E+02 gamma(00000386)=0.130168904233344E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 386 z1= 1 0.349368086752493E-05 0.000000000000000E+00 z1= 2 -.969037679933059E-03 0.000000000000000E+00 z1= 3 -.289358134168368E-08 0.000000000000000E+00 alpha(00000386)=0.000000000000000E+00 beta (00000387)=0.129062729006450E+02 gamma(00000387)=0.129062729006450E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 387 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000387)=0.000000000000000E+00 beta (00000388)=0.133571597248837E+02 gamma(00000388)=0.133571597248837E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 388 z1= 1 -.357728884061055E-05 0.000000000000000E+00 z1= 2 0.840220090467947E-03 0.000000000000000E+00 z1= 3 0.106460529828074E-06 0.000000000000000E+00 alpha(00000388)=0.000000000000000E+00 beta (00000389)=0.125858317751283E+02 gamma(00000389)=0.125858317751283E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 389 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000389)=0.000000000000000E+00 beta (00000390)=0.134760429776503E+02 gamma(00000390)=0.134760429776503E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 390 z1= 1 0.351958657916459E-05 0.000000000000000E+00 z1= 2 -.731734077203564E-03 0.000000000000000E+00 z1= 3 -.172613846228755E-06 0.000000000000000E+00 alpha(00000390)=0.000000000000000E+00 beta (00000391)=0.129061712129303E+02 gamma(00000391)=0.129061712129303E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 391 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000391)=0.000000000000000E+00 beta (00000392)=0.131950581629851E+02 gamma(00000392)=0.131950581629851E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 392 z1= 1 -.362885608417175E-05 0.000000000000000E+00 z1= 2 0.745981531161233E-03 0.000000000000000E+00 z1= 3 0.273396605524073E-06 0.000000000000000E+00 alpha(00000392)=0.000000000000000E+00 beta (00000393)=0.126542812444308E+02 gamma(00000393)=0.126542812444308E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 393 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000393)=0.000000000000000E+00 beta (00000394)=0.133841499383001E+02 gamma(00000394)=0.133841499383001E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 394 z1= 1 0.359633796105305E-05 0.000000000000000E+00 z1= 2 -.723044751080653E-03 0.000000000000000E+00 z1= 3 -.339851680686450E-06 0.000000000000000E+00 alpha(00000394)=0.000000000000000E+00 beta (00000395)=0.126876730109873E+02 gamma(00000395)=0.126876730109873E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 395 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000395)=0.000000000000000E+00 beta (00000396)=0.132038045765396E+02 gamma(00000396)=0.132038045765396E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 396 z1= 1 -.363865379217126E-05 0.000000000000000E+00 z1= 2 0.634979313319250E-03 0.000000000000000E+00 z1= 3 0.417205462270305E-06 0.000000000000000E+00 alpha(00000396)=0.000000000000000E+00 beta (00000397)=0.127102581571091E+02 gamma(00000397)=0.127102581571091E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 397 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000397)=0.000000000000000E+00 beta (00000398)=0.131579818718247E+02 gamma(00000398)=0.131579818718247E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 398 z1= 1 0.367846567474748E-05 0.000000000000000E+00 z1= 2 -.431148517535196E-03 0.000000000000000E+00 z1= 3 -.502237059472627E-06 0.000000000000000E+00 alpha(00000398)=0.000000000000000E+00 beta (00000399)=0.126877604588753E+02 gamma(00000399)=0.126877604588753E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 399 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000399)=0.000000000000000E+00 beta (00000400)=0.136083939369632E+02 gamma(00000400)=0.136083939369632E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 400 z1= 1 -.359826032694625E-05 0.000000000000000E+00 z1= 2 0.190024910658445E-03 0.000000000000000E+00 z1= 3 0.526372064885901E-06 0.000000000000000E+00 alpha(00000400)=0.000000000000000E+00 beta (00000401)=0.128719373783732E+02 gamma(00000401)=0.128719373783732E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 401 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000401)=0.000000000000000E+00 beta (00000402)=0.132282577984509E+02 gamma(00000402)=0.132282577984509E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 402 z1= 1 0.365880150319207E-05 0.000000000000000E+00 z1= 2 0.834973158655473E-04 0.000000000000000E+00 z1= 3 -.611982304428037E-06 0.000000000000000E+00 alpha(00000402)=0.000000000000000E+00 beta (00000403)=0.129674358772304E+02 gamma(00000403)=0.129674358772304E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 403 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000403)=0.000000000000000E+00 beta (00000404)=0.133464196466581E+02 gamma(00000404)=0.133464196466581E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 404 z1= 1 -.371390583896614E-05 0.000000000000000E+00 z1= 2 -.280705032072587E-03 0.000000000000000E+00 z1= 3 0.650948769806902E-06 0.000000000000000E+00 alpha(00000404)=0.000000000000000E+00 beta (00000405)=0.126603062757557E+02 gamma(00000405)=0.126603062757557E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 405 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000405)=0.000000000000000E+00 beta (00000406)=0.135477412413881E+02 gamma(00000406)=0.135477412413881E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 406 z1= 1 0.361804831679278E-05 0.000000000000000E+00 z1= 2 0.445888240212498E-03 0.000000000000000E+00 z1= 3 -.679839227900889E-06 0.000000000000000E+00 alpha(00000406)=0.000000000000000E+00 beta (00000407)=0.127114666768916E+02 gamma(00000407)=0.127114666768916E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 407 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000407)=0.000000000000000E+00 beta (00000408)=0.130764904689422E+02 gamma(00000408)=0.130764904689422E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 408 z1= 1 -.368946997887079E-05 0.000000000000000E+00 z1= 2 -.686897950187320E-03 0.000000000000000E+00 z1= 3 0.679211198451534E-06 0.000000000000000E+00 alpha(00000408)=0.000000000000000E+00 beta (00000409)=0.129445408073245E+02 gamma(00000409)=0.129445408073245E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 409 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000409)=0.000000000000000E+00 beta (00000410)=0.133572063812707E+02 gamma(00000410)=0.133572063812707E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 410 z1= 1 0.374706036588342E-05 0.000000000000000E+00 z1= 2 0.927479634521243E-03 0.000000000000000E+00 z1= 3 -.731784780002339E-06 0.000000000000000E+00 alpha(00000410)=0.000000000000000E+00 beta (00000411)=0.128095650916903E+02 gamma(00000411)=0.128095650916903E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 411 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000411)=0.000000000000000E+00 beta (00000412)=0.138140886114727E+02 gamma(00000412)=0.138140886114727E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 412 z1= 1 -.363391926908041E-05 0.000000000000000E+00 z1= 2 -.106201188247809E-02 0.000000000000000E+00 z1= 3 0.697349372328075E-06 0.000000000000000E+00 alpha(00000412)=0.000000000000000E+00 beta (00000413)=0.124499131667514E+02 gamma(00000413)=0.124499131667514E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 413 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000413)=0.000000000000000E+00 beta (00000414)=0.133787649097590E+02 gamma(00000414)=0.133787649097590E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 414 z1= 1 0.355693592595614E-05 0.000000000000000E+00 z1= 2 0.111324644054363E-02 0.000000000000000E+00 z1= 3 -.729228361545751E-06 0.000000000000000E+00 alpha(00000414)=0.000000000000000E+00 beta (00000415)=0.130605899516051E+02 gamma(00000415)=0.130605899516051E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 415 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000415)=0.000000000000000E+00 beta (00000416)=0.135228179007108E+02 gamma(00000416)=0.135228179007108E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 416 z1= 1 -.360897485866493E-05 0.000000000000000E+00 z1= 2 -.106535834618177E-02 0.000000000000000E+00 z1= 3 0.706460358011128E-06 0.000000000000000E+00 alpha(00000416)=0.000000000000000E+00 beta (00000417)=0.126275304977541E+02 gamma(00000417)=0.126275304977541E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 417 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000417)=0.000000000000000E+00 beta (00000418)=0.138147934305683E+02 gamma(00000418)=0.138147934305683E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 418 z1= 1 0.347843557684099E-05 0.000000000000000E+00 z1= 2 0.855620705475901E-03 0.000000000000000E+00 z1= 3 -.721907126675393E-06 0.000000000000000E+00 alpha(00000418)=0.000000000000000E+00 beta (00000419)=0.126621225811536E+02 gamma(00000419)=0.126621225811536E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 419 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000419)=0.000000000000000E+00 beta (00000420)=0.135334940445231E+02 gamma(00000420)=0.135334940445231E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 420 z1= 1 -.343538321197906E-05 0.000000000000000E+00 z1= 2 -.679875609601815E-03 0.000000000000000E+00 z1= 3 0.663910259974496E-06 0.000000000000000E+00 alpha(00000420)=0.000000000000000E+00 beta (00000421)=0.128427744910704E+02 gamma(00000421)=0.128427744910704E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 421 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000421)=0.000000000000000E+00 beta (00000422)=0.130972320637599E+02 gamma(00000422)=0.130972320637599E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 422 z1= 1 0.355054161505029E-05 0.000000000000000E+00 z1= 2 0.621534002788993E-03 0.000000000000000E+00 z1= 3 -.695305420185608E-06 0.000000000000000E+00 alpha(00000422)=0.000000000000000E+00 beta (00000423)=0.127561505001919E+02 gamma(00000423)=0.127561505001919E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 423 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000423)=0.000000000000000E+00 beta (00000424)=0.136009960440677E+02 gamma(00000424)=0.136009960440677E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 424 z1= 1 -.350315878271980E-05 0.000000000000000E+00 z1= 2 -.547642060654080E-03 0.000000000000000E+00 z1= 3 0.607564466720235E-06 0.000000000000000E+00 alpha(00000424)=0.000000000000000E+00 beta (00000425)=0.123518136165995E+02 gamma(00000425)=0.123518136165995E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 425 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000425)=0.000000000000000E+00 beta (00000426)=0.137429597652421E+02 gamma(00000426)=0.137429597652421E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 426 z1= 1 0.332417002043683E-05 0.000000000000000E+00 z1= 2 0.422026353286911E-03 0.000000000000000E+00 z1= 3 -.577895558432728E-06 0.000000000000000E+00 alpha(00000426)=0.000000000000000E+00 beta (00000427)=0.127408175125267E+02 gamma(00000427)=0.127408175125267E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 427 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000427)=0.000000000000000E+00 beta (00000428)=0.133045013679117E+02 gamma(00000428)=0.133045013679117E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 428 z1= 1 -.336402921859592E-05 0.000000000000000E+00 z1= 2 -.212860751469405E-03 0.000000000000000E+00 z1= 3 0.516814810487412E-06 0.000000000000000E+00 alpha(00000428)=0.000000000000000E+00 beta (00000429)=0.128353464628649E+02 gamma(00000429)=0.128353464628649E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 429 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000429)=0.000000000000000E+00 beta (00000430)=0.132090521151817E+02 gamma(00000430)=0.132090521151817E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 430 z1= 1 0.345568304754677E-05 0.000000000000000E+00 z1= 2 -.141169383338177E-03 0.000000000000000E+00 z1= 3 -.528274203776945E-06 0.000000000000000E+00 alpha(00000430)=0.000000000000000E+00 beta (00000431)=0.129472394895322E+02 gamma(00000431)=0.129472394895322E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 431 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000431)=0.000000000000000E+00 beta (00000432)=0.135190728141264E+02 gamma(00000432)=0.135190728141264E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 432 z1= 1 -.347200138584546E-05 0.000000000000000E+00 z1= 2 0.469690044792904E-03 0.000000000000000E+00 z1= 3 0.457602486605676E-06 0.000000000000000E+00 alpha(00000432)=0.000000000000000E+00 beta (00000433)=0.125895523028154E+02 gamma(00000433)=0.125895523028154E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 433 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000433)=0.000000000000000E+00 beta (00000434)=0.137837538622083E+02 gamma(00000434)=0.137837538622083E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 434 z1= 1 0.333708611226918E-05 0.000000000000000E+00 z1= 2 -.699398844076347E-03 0.000000000000000E+00 z1= 3 -.448409663487493E-06 0.000000000000000E+00 alpha(00000434)=0.000000000000000E+00 beta (00000435)=0.128837839408683E+02 gamma(00000435)=0.128837839408683E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 435 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000435)=0.000000000000000E+00 beta (00000436)=0.132266197108807E+02 gamma(00000436)=0.132266197108807E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 436 z1= 1 -.343407201691768E-05 0.000000000000000E+00 z1= 2 0.900452815317272E-03 0.000000000000000E+00 z1= 3 0.406457691743767E-06 0.000000000000000E+00 alpha(00000436)=0.000000000000000E+00 beta (00000437)=0.129067967076268E+02 gamma(00000437)=0.129067967076268E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 437 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000437)=0.000000000000000E+00 beta (00000438)=0.128547296033026E+02 gamma(00000438)=0.128547296033026E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 438 z1= 1 0.364543076266256E-05 0.000000000000000E+00 z1= 2 -.935461943856887E-03 0.000000000000000E+00 z1= 3 -.415973321438775E-06 0.000000000000000E+00 alpha(00000438)=0.000000000000000E+00 beta (00000439)=0.127824558443860E+02 gamma(00000439)=0.127824558443860E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 439 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000439)=0.000000000000000E+00 beta (00000440)=0.133184611926670E+02 gamma(00000440)=0.133184611926670E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 440 z1= 1 -.369896078665152E-05 0.000000000000000E+00 z1= 2 0.810604481258283E-03 0.000000000000000E+00 z1= 3 0.386159868625289E-06 0.000000000000000E+00 alpha(00000440)=0.000000000000000E+00 beta (00000441)=0.124654952687681E+02 gamma(00000441)=0.124654952687681E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 441 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000441)=0.000000000000000E+00 beta (00000442)=0.134802932901439E+02 gamma(00000442)=0.134802932901439E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 442 z1= 1 0.361674075033489E-05 0.000000000000000E+00 z1= 2 -.516541111349057E-03 0.000000000000000E+00 z1= 3 -.370438596550325E-06 0.000000000000000E+00 alpha(00000442)=0.000000000000000E+00 beta (00000443)=0.125905814656399E+02 gamma(00000443)=0.125905814656399E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 443 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000443)=0.000000000000000E+00 beta (00000444)=0.133373876732618E+02 gamma(00000444)=0.133373876732618E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 444 z1= 1 -.363007190928508E-05 0.000000000000000E+00 z1= 2 0.180622442486240E-03 0.000000000000000E+00 z1= 3 0.358373264400073E-06 0.000000000000000E+00 alpha(00000444)=0.000000000000000E+00 beta (00000445)=0.132098636244196E+02 gamma(00000445)=0.132098636244196E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 445 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000445)=0.000000000000000E+00 beta (00000446)=0.130285542047167E+02 gamma(00000446)=0.130285542047167E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 446 z1= 1 0.390309292262227E-05 0.000000000000000E+00 z1= 2 0.129982952726333E-03 0.000000000000000E+00 z1= 3 -.370745092048794E-06 0.000000000000000E+00 alpha(00000446)=0.000000000000000E+00 beta (00000447)=0.129522392874696E+02 gamma(00000447)=0.129522392874696E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 447 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000447)=0.000000000000000E+00 beta (00000448)=0.132092081359833E+02 gamma(00000448)=0.132092081359833E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 448 z1= 1 -.403731442919116E-05 0.000000000000000E+00 z1= 2 -.343879506753389E-03 0.000000000000000E+00 z1= 3 0.391038914596565E-06 0.000000000000000E+00 alpha(00000448)=0.000000000000000E+00 beta (00000449)=0.129489725602347E+02 gamma(00000449)=0.129489725602347E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 449 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000449)=0.000000000000000E+00 beta (00000450)=0.136503991375937E+02 gamma(00000450)=0.136503991375937E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 450 z1= 1 0.401721308441148E-05 0.000000000000000E+00 z1= 2 0.462324990944856E-03 0.000000000000000E+00 z1= 3 -.377777717645682E-06 0.000000000000000E+00 alpha(00000450)=0.000000000000000E+00 beta (00000451)=0.124501778501954E+02 gamma(00000451)=0.124501778501954E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 451 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000451)=0.000000000000000E+00 beta (00000452)=0.137434161894415E+02 gamma(00000452)=0.137434161894415E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 452 z1= 1 -.382862144499355E-05 0.000000000000000E+00 z1= 2 -.621767500823111E-03 0.000000000000000E+00 z1= 3 0.375226719293888E-06 0.000000000000000E+00 alpha(00000452)=0.000000000000000E+00 beta (00000453)=0.123492999674624E+02 gamma(00000453)=0.123492999674624E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 453 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000453)=0.000000000000000E+00 beta (00000454)=0.136342991977854E+02 gamma(00000454)=0.136342991977854E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 454 z1= 1 0.367572793649740E-05 0.000000000000000E+00 z1= 2 0.740977985282658E-03 0.000000000000000E+00 z1= 3 -.313670673498991E-06 0.000000000000000E+00 alpha(00000454)=0.000000000000000E+00 beta (00000455)=0.124949114503783E+02 gamma(00000455)=0.124949114503783E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 455 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000455)=0.000000000000000E+00 beta (00000456)=0.136130166845993E+02 gamma(00000456)=0.136130166845993E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 456 z1= 1 -.358706103227233E-05 0.000000000000000E+00 z1= 2 -.936906525542826E-03 0.000000000000000E+00 z1= 3 0.305161748468844E-06 0.000000000000000E+00 alpha(00000456)=0.000000000000000E+00 beta (00000457)=0.127298154592947E+02 gamma(00000457)=0.127298154592947E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 457 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000457)=0.000000000000000E+00 beta (00000458)=0.134663545657473E+02 gamma(00000458)=0.134663545657473E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 458 z1= 1 0.361745209026803E-05 0.000000000000000E+00 z1= 2 0.110740060609719E-02 0.000000000000000E+00 z1= 3 -.225432269697812E-06 0.000000000000000E+00 alpha(00000458)=0.000000000000000E+00 beta (00000459)=0.129361010162124E+02 gamma(00000459)=0.129361010162124E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 459 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000459)=0.000000000000000E+00 beta (00000460)=0.134362676828306E+02 gamma(00000460)=0.134362676828306E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 460 z1= 1 -.371429502775888E-05 0.000000000000000E+00 z1= 2 -.121695328941353E-02 0.000000000000000E+00 z1= 3 0.222373480037721E-06 0.000000000000000E+00 alpha(00000460)=0.000000000000000E+00 beta (00000461)=0.127149953015401E+02 gamma(00000461)=0.127149953015401E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 461 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000461)=0.000000000000000E+00 beta (00000462)=0.133073122674314E+02 gamma(00000462)=0.133073122674314E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 462 z1= 1 0.377726007610730E-05 0.000000000000000E+00 z1= 2 0.123537531927305E-02 0.000000000000000E+00 z1= 3 -.116130022030777E-06 0.000000000000000E+00 alpha(00000462)=0.000000000000000E+00 beta (00000463)=0.130288453076303E+02 gamma(00000463)=0.130288453076303E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 463 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000463)=0.000000000000000E+00 beta (00000464)=0.134211060905844E+02 gamma(00000464)=0.134211060905844E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 464 z1= 1 -.389719241943292E-05 0.000000000000000E+00 z1= 2 -.114511682555913E-02 0.000000000000000E+00 z1= 3 0.962383694459203E-07 0.000000000000000E+00 alpha(00000464)=0.000000000000000E+00 beta (00000465)=0.126554462145019E+02 gamma(00000465)=0.126554462145019E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 465 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000465)=0.000000000000000E+00 beta (00000466)=0.134457826308683E+02 gamma(00000466)=0.134457826308683E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 466 z1= 1 0.388272020129246E-05 0.000000000000000E+00 z1= 2 0.100079602373440E-02 0.000000000000000E+00 z1= 3 0.103615708450366E-07 0.000000000000000E+00 alpha(00000466)=0.000000000000000E+00 beta (00000467)=0.128140938876774E+02 gamma(00000467)=0.128140938876774E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 467 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000467)=0.000000000000000E+00 beta (00000468)=0.136873194859020E+02 gamma(00000468)=0.136873194859020E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 468 z1= 1 -.385435846205623E-05 0.000000000000000E+00 z1= 2 -.837717180515994E-03 0.000000000000000E+00 z1= 3 -.441254881136492E-08 0.000000000000000E+00 alpha(00000468)=0.000000000000000E+00 beta (00000469)=0.126931626857742E+02 gamma(00000469)=0.126931626857742E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 469 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000469)=0.000000000000000E+00 beta (00000470)=0.136810341469459E+02 gamma(00000470)=0.136810341469459E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 470 z1= 1 0.380378445662252E-05 0.000000000000000E+00 z1= 2 0.602975479098504E-03 0.000000000000000E+00 z1= 3 0.106929277971673E-06 0.000000000000000E+00 alpha(00000470)=0.000000000000000E+00 beta (00000471)=0.127563523479081E+02 gamma(00000471)=0.127563523479081E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 471 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000471)=0.000000000000000E+00 beta (00000472)=0.133838540435056E+02 gamma(00000472)=0.133838540435056E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 472 z1= 1 -.385238014576224E-05 0.000000000000000E+00 z1= 2 -.376681801736627E-03 0.000000000000000E+00 z1= 3 -.116924598616810E-06 0.000000000000000E+00 alpha(00000472)=0.000000000000000E+00 beta (00000473)=0.126367552995957E+02 gamma(00000473)=0.126367552995957E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 473 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000473)=0.000000000000000E+00 beta (00000474)=0.134964239947119E+02 gamma(00000474)=0.134964239947119E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 474 z1= 1 0.384661644548022E-05 0.000000000000000E+00 z1= 2 0.138496659420622E-03 0.000000000000000E+00 z1= 3 0.192700810342064E-06 0.000000000000000E+00 alpha(00000474)=0.000000000000000E+00 beta (00000475)=0.127392694980907E+02 gamma(00000475)=0.127392694980907E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 475 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000475)=0.000000000000000E+00 beta (00000476)=0.133043228983343E+02 gamma(00000476)=0.133043228983343E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 476 z1= 1 -.393603089376016E-05 0.000000000000000E+00 z1= 2 -.361349867333697E-05 0.000000000000000E+00 z1= 3 -.185416828925148E-06 0.000000000000000E+00 alpha(00000476)=0.000000000000000E+00 beta (00000477)=0.126415231247151E+02 gamma(00000477)=0.126415231247151E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 477 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000477)=0.000000000000000E+00 beta (00000478)=0.133306153906395E+02 gamma(00000478)=0.133306153906395E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 478 z1= 1 0.400483632541143E-05 0.000000000000000E+00 z1= 2 -.892581267927213E-04 0.000000000000000E+00 z1= 3 0.234680171025024E-06 0.000000000000000E+00 alpha(00000478)=0.000000000000000E+00 beta (00000479)=0.126280433653617E+02 gamma(00000479)=0.126280433653617E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 479 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000479)=0.000000000000000E+00 beta (00000480)=0.133935295738204E+02 gamma(00000480)=0.133935295738204E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 480 z1= 1 -.406047907299282E-05 0.000000000000000E+00 z1= 2 0.171129993285586E-03 0.000000000000000E+00 z1= 3 -.259820994054220E-06 0.000000000000000E+00 alpha(00000480)=0.000000000000000E+00 beta (00000481)=0.126439269780216E+02 gamma(00000481)=0.126439269780216E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 481 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000481)=0.000000000000000E+00 beta (00000482)=0.134762718104060E+02 gamma(00000482)=0.134762718104060E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 482 z1= 1 0.410442487184691E-05 0.000000000000000E+00 z1= 2 -.274985388259063E-03 0.000000000000000E+00 z1= 3 0.286610254445234E-06 0.000000000000000E+00 alpha(00000482)=0.000000000000000E+00 beta (00000483)=0.127040159358471E+02 gamma(00000483)=0.127040159358471E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 483 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000483)=0.000000000000000E+00 beta (00000484)=0.136554971595844E+02 gamma(00000484)=0.136554971595844E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 484 z1= 1 -.411075902353878E-05 0.000000000000000E+00 z1= 2 0.373607202666281E-03 0.000000000000000E+00 z1= 3 -.296537459572668E-06 0.000000000000000E+00 alpha(00000484)=0.000000000000000E+00 beta (00000485)=0.126719379371227E+02 gamma(00000485)=0.126719379371227E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 485 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000485)=0.000000000000000E+00 beta (00000486)=0.132368008344103E+02 gamma(00000486)=0.132368008344103E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 486 z1= 1 0.426985814170298E-05 0.000000000000000E+00 z1= 2 -.477543466164154E-03 0.000000000000000E+00 z1= 3 0.325889418886056E-06 0.000000000000000E+00 alpha(00000486)=0.000000000000000E+00 beta (00000487)=0.124437256634576E+02 gamma(00000487)=0.124437256634576E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 487 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000487)=0.000000000000000E+00 beta (00000488)=0.134512608676438E+02 gamma(00000488)=0.134512608676438E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 488 z1= 1 -.428405639035030E-05 0.000000000000000E+00 z1= 2 0.507265177128253E-03 0.000000000000000E+00 z1= 3 -.401935508998581E-06 0.000000000000000E+00 alpha(00000488)=0.000000000000000E+00 beta (00000489)=0.128384065191086E+02 gamma(00000489)=0.128384065191086E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 489 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000489)=0.000000000000000E+00 beta (00000490)=0.132658316068932E+02 gamma(00000490)=0.132658316068932E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 490 z1= 1 0.450465773829505E-05 0.000000000000000E+00 z1= 2 -.576614036274102E-03 0.000000000000000E+00 z1= 3 0.406563605367044E-06 0.000000000000000E+00 alpha(00000490)=0.000000000000000E+00 beta (00000491)=0.125999664114415E+02 gamma(00000491)=0.125999664114415E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 491 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000491)=0.000000000000000E+00 beta (00000492)=0.134509688544327E+02 gamma(00000492)=0.134509688544327E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 492 z1= 1 -.456365775917782E-05 0.000000000000000E+00 z1= 2 0.648837667894138E-03 0.000000000000000E+00 z1= 3 -.469353097401075E-06 0.000000000000000E+00 alpha(00000492)=0.000000000000000E+00 beta (00000493)=0.127242824294439E+02 gamma(00000493)=0.127242824294439E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 493 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000493)=0.000000000000000E+00 beta (00000494)=0.132863303758182E+02 gamma(00000494)=0.132863303758182E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 494 z1= 1 0.473671558561158E-05 0.000000000000000E+00 z1= 2 -.798264601193603E-03 0.000000000000000E+00 z1= 3 0.445719906998584E-06 0.000000000000000E+00 alpha(00000494)=0.000000000000000E+00 beta (00000495)=0.124537545091124E+02 gamma(00000495)=0.124537545091124E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 495 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000495)=0.000000000000000E+00 beta (00000496)=0.134982416403500E+02 gamma(00000496)=0.134982416403500E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 496 z1= 1 -.471992126898453E-05 0.000000000000000E+00 z1= 2 0.848303688547713E-03 0.000000000000000E+00 z1= 3 -.552592860073525E-06 0.000000000000000E+00 alpha(00000496)=0.000000000000000E+00 beta (00000497)=0.128385631395059E+02 gamma(00000497)=0.128385631395059E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 497 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000497)=0.000000000000000E+00 beta (00000498)=0.133352467450784E+02 gamma(00000498)=0.133352467450784E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 498 z1= 1 0.494108690180352E-05 0.000000000000000E+00 z1= 2 -.918828559944174E-03 0.000000000000000E+00 z1= 3 0.500210080791805E-06 0.000000000000000E+00 alpha(00000498)=0.000000000000000E+00 beta (00000499)=0.126817729924288E+02 gamma(00000499)=0.126817729924288E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 499 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000499)=0.000000000000000E+00 beta (00000500)=0.134573919767135E+02 gamma(00000500)=0.134573919767135E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 500 z1= 1 -.502620231023322E-05 0.000000000000000E+00 z1= 2 0.105285130001619E-02 0.000000000000000E+00 z1= 3 -.662713477186878E-06 0.000000000000000E+00 alpha(00000500)=0.000000000000000E+00 beta (00000501)=0.127047234459536E+02 gamma(00000501)=0.127047234459536E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Norm of initial Lanczos vectors= 1.841652243191165 Starting Lanczos loop 3 Lanczos iteration: 1 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal alpha(00000001)=0.000000000000000E+00 beta (00000002)=0.171988313361988E+01 gamma(00000002)=0.171988313361988E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 2 z1= 1 0.663024870149157E-06 0.000000000000000E+00 z1= 2 -.221874526081141E-05 0.000000000000000E+00 z1= 3 0.124520560488345E+01 0.000000000000000E+00 alpha(00000002)=0.000000000000000E+00 beta (00000003)=0.476672412555626E+01 gamma(00000003)=0.476672412555626E+01 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 3 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000003)=0.000000000000000E+00 beta (00000004)=0.135455786704734E+02 gamma(00000004)=0.135455786704734E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 4 z1= 1 -.218065605493115E-06 0.000000000000000E+00 z1= 2 0.772582398582389E-06 0.000000000000000E+00 z1= 3 -.355940981942414E+00 0.000000000000000E+00 alpha(00000004)=0.000000000000000E+00 beta (00000005)=0.127184753500732E+02 gamma(00000005)=0.127184753500732E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 5 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000005)=0.000000000000000E+00 beta (00000006)=0.134778619466885E+02 gamma(00000006)=0.134778619466885E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 6 z1= 1 0.220907282646955E-06 0.000000000000000E+00 z1= 2 -.747562628365119E-06 0.000000000000000E+00 z1= 3 0.303457752222706E+00 0.000000000000000E+00 alpha(00000006)=0.000000000000000E+00 beta (00000007)=0.128879311184969E+02 gamma(00000007)=0.128879311184969E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 7 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000007)=0.000000000000000E+00 beta (00000008)=0.133738577579146E+02 gamma(00000008)=0.133738577579146E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 8 z1= 1 -.240226473592576E-06 0.000000000000000E+00 z1= 2 0.768083316857431E-06 0.000000000000000E+00 z1= 3 -.273900448948058E+00 0.000000000000000E+00 alpha(00000008)=0.000000000000000E+00 beta (00000009)=0.128588191679613E+02 gamma(00000009)=0.128588191679613E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 9 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000009)=0.000000000000000E+00 beta (00000010)=0.134143954539029E+02 gamma(00000010)=0.134143954539029E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 10 z1= 1 0.261131678431874E-06 0.000000000000000E+00 z1= 2 -.825782731452468E-06 0.000000000000000E+00 z1= 3 0.250162592949930E+00 0.000000000000000E+00 alpha(00000010)=0.000000000000000E+00 beta (00000011)=0.128242598091633E+02 gamma(00000011)=0.128242598091633E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 11 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000011)=0.000000000000000E+00 beta (00000012)=0.134762977044858E+02 gamma(00000012)=0.134762977044858E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 12 z1= 1 -.281917697415597E-06 0.000000000000000E+00 z1= 2 0.921156892876973E-06 0.000000000000000E+00 z1= 3 -.228558621650782E+00 0.000000000000000E+00 alpha(00000012)=0.000000000000000E+00 beta (00000013)=0.128064561057340E+02 gamma(00000013)=0.128064561057340E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 13 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000013)=0.000000000000000E+00 beta (00000014)=0.134982188405027E+02 gamma(00000014)=0.134982188405027E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 14 z1= 1 0.297585411956989E-06 0.000000000000000E+00 z1= 2 -.102974030132230E-05 0.000000000000000E+00 z1= 3 0.209175967422532E+00 0.000000000000000E+00 alpha(00000014)=0.000000000000000E+00 beta (00000015)=0.128005687364523E+02 gamma(00000015)=0.128005687364523E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 15 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000015)=0.000000000000000E+00 beta (00000016)=0.134714910841036E+02 gamma(00000016)=0.134714910841036E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 16 z1= 1 -.303854358656359E-06 0.000000000000000E+00 z1= 2 0.109461702337406E-05 0.000000000000000E+00 z1= 3 -.192297212726838E+00 0.000000000000000E+00 alpha(00000016)=0.000000000000000E+00 beta (00000017)=0.127887234806921E+02 gamma(00000017)=0.127887234806921E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 17 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000017)=0.000000000000000E+00 beta (00000018)=0.134266128561788E+02 gamma(00000018)=0.134266128561788E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 18 z1= 1 0.300869893649525E-06 0.000000000000000E+00 z1= 2 -.113334599945408E-05 0.000000000000000E+00 z1= 3 0.177688788793802E+00 0.000000000000000E+00 alpha(00000018)=0.000000000000000E+00 beta (00000019)=0.127825646126019E+02 gamma(00000019)=0.127825646126019E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 19 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000019)=0.000000000000000E+00 beta (00000020)=0.134080184983689E+02 gamma(00000020)=0.134080184983689E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 20 z1= 1 -.298949234518926E-06 0.000000000000000E+00 z1= 2 0.117784470543119E-05 0.000000000000000E+00 z1= 3 -.164706990139644E+00 0.000000000000000E+00 alpha(00000020)=0.000000000000000E+00 beta (00000021)=0.128007404121685E+02 gamma(00000021)=0.128007404121685E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 21 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000021)=0.000000000000000E+00 beta (00000022)=0.134207211905906E+02 gamma(00000022)=0.134207211905906E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 22 z1= 1 0.288982807469069E-06 0.000000000000000E+00 z1= 2 -.121029811412195E-05 0.000000000000000E+00 z1= 3 0.153073333256714E+00 0.000000000000000E+00 alpha(00000022)=0.000000000000000E+00 beta (00000023)=0.128225869589224E+02 gamma(00000023)=0.128225869589224E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 23 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000023)=0.000000000000000E+00 beta (00000024)=0.134332940013601E+02 gamma(00000024)=0.134332940013601E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 24 z1= 1 -.279647892602200E-06 0.000000000000000E+00 z1= 2 0.123680828741280E-05 0.000000000000000E+00 z1= 3 -.142654243316873E+00 0.000000000000000E+00 alpha(00000024)=0.000000000000000E+00 beta (00000025)=0.128311425405846E+02 gamma(00000025)=0.128311425405846E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 25 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000025)=0.000000000000000E+00 beta (00000026)=0.134383817111015E+02 gamma(00000026)=0.134383817111015E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 26 z1= 1 0.294179617131628E-06 0.000000000000000E+00 z1= 2 -.128086543713996E-05 0.000000000000000E+00 z1= 3 0.133199149916755E+00 0.000000000000000E+00 alpha(00000026)=0.000000000000000E+00 beta (00000027)=0.128182296551777E+02 gamma(00000027)=0.128182296551777E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 27 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000027)=0.000000000000000E+00 beta (00000028)=0.134102237461998E+02 gamma(00000028)=0.134102237461998E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 28 z1= 1 -.320976764538173E-06 0.000000000000000E+00 z1= 2 0.133901508960128E-05 0.000000000000000E+00 z1= 3 -.124698680014893E+00 0.000000000000000E+00 alpha(00000028)=0.000000000000000E+00 beta (00000029)=0.127846800785557E+02 gamma(00000029)=0.127846800785557E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 29 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000029)=0.000000000000000E+00 beta (00000030)=0.134134193817761E+02 gamma(00000030)=0.134134193817761E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 30 z1= 1 0.338562926681949E-06 0.000000000000000E+00 z1= 2 -.138983355372016E-05 0.000000000000000E+00 z1= 3 0.116545365572387E+00 0.000000000000000E+00 alpha(00000030)=0.000000000000000E+00 beta (00000031)=0.128191564641331E+02 gamma(00000031)=0.128191564641331E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 31 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000031)=0.000000000000000E+00 beta (00000032)=0.134293990269944E+02 gamma(00000032)=0.134293990269944E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 32 z1= 1 -.341784320734338E-06 0.000000000000000E+00 z1= 2 0.141901826804464E-05 0.000000000000000E+00 z1= 3 -.109214842777851E+00 0.000000000000000E+00 alpha(00000032)=0.000000000000000E+00 beta (00000033)=0.127671198794421E+02 gamma(00000033)=0.127671198794421E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 33 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000033)=0.000000000000000E+00 beta (00000034)=0.133586616949687E+02 gamma(00000034)=0.133586616949687E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 34 z1= 1 0.350529223967853E-06 0.000000000000000E+00 z1= 2 -.142378112529592E-05 0.000000000000000E+00 z1= 3 0.102544092984169E+00 0.000000000000000E+00 alpha(00000034)=0.000000000000000E+00 beta (00000035)=0.127703298345296E+02 gamma(00000035)=0.127703298345296E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 35 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000035)=0.000000000000000E+00 beta (00000036)=0.134311087248697E+02 gamma(00000036)=0.134311087248697E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 36 z1= 1 -.356806888056338E-06 0.000000000000000E+00 z1= 2 0.143203887414977E-05 0.000000000000000E+00 z1= 3 -.958472619747496E-01 0.000000000000000E+00 alpha(00000036)=0.000000000000000E+00 beta (00000037)=0.128060595749493E+02 gamma(00000037)=0.128060595749493E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 37 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000037)=0.000000000000000E+00 beta (00000038)=0.133888950734320E+02 gamma(00000038)=0.133888950734320E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 38 z1= 1 0.361313651571884E-06 0.000000000000000E+00 z1= 2 -.145878397683676E-05 0.000000000000000E+00 z1= 3 0.901628873529649E-01 0.000000000000000E+00 alpha(00000038)=0.000000000000000E+00 beta (00000039)=0.127549655687250E+02 gamma(00000039)=0.127549655687250E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 39 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000039)=0.000000000000000E+00 beta (00000040)=0.133497030376504E+02 gamma(00000040)=0.133497030376504E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 40 z1= 1 -.360471646850512E-06 0.000000000000000E+00 z1= 2 0.147326742005376E-05 0.000000000000000E+00 z1= 3 -.847503407324605E-01 0.000000000000000E+00 alpha(00000040)=0.000000000000000E+00 beta (00000041)=0.126995484221466E+02 gamma(00000041)=0.126995484221466E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 41 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000041)=0.000000000000000E+00 beta (00000042)=0.133246744291924E+02 gamma(00000042)=0.133246744291924E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 42 z1= 1 0.353902049887939E-06 0.000000000000000E+00 z1= 2 -.147642381517071E-05 0.000000000000000E+00 z1= 3 0.794598584147741E-01 0.000000000000000E+00 alpha(00000042)=0.000000000000000E+00 beta (00000043)=0.127528434792520E+02 gamma(00000043)=0.127528434792520E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 43 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000043)=0.000000000000000E+00 beta (00000044)=0.133691964378152E+02 gamma(00000044)=0.133691964378152E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 44 z1= 1 -.361257604872376E-06 0.000000000000000E+00 z1= 2 0.148742638145141E-05 0.000000000000000E+00 z1= 3 -.746055315154542E-01 0.000000000000000E+00 alpha(00000044)=0.000000000000000E+00 beta (00000045)=0.127653035038065E+02 gamma(00000045)=0.127653035038065E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 45 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000045)=0.000000000000000E+00 beta (00000046)=0.134072287447016E+02 gamma(00000046)=0.134072287447016E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 46 z1= 1 0.365517339245987E-06 0.000000000000000E+00 z1= 2 -.148311795662823E-05 0.000000000000000E+00 z1= 3 0.699094235000442E-01 0.000000000000000E+00 alpha(00000046)=0.000000000000000E+00 beta (00000047)=0.127671169271027E+02 gamma(00000047)=0.127671169271027E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 47 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000047)=0.000000000000000E+00 beta (00000048)=0.133557555202584E+02 gamma(00000048)=0.133557555202584E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 48 z1= 1 -.360573435163967E-06 0.000000000000000E+00 z1= 2 0.147117097934663E-05 0.000000000000000E+00 z1= 3 -.657702440464821E-01 0.000000000000000E+00 alpha(00000048)=0.000000000000000E+00 beta (00000049)=0.128436220916604E+02 gamma(00000049)=0.128436220916604E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 49 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000049)=0.000000000000000E+00 beta (00000050)=0.134358287671511E+02 gamma(00000050)=0.134358287671511E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 50 z1= 1 0.362310962593736E-06 0.000000000000000E+00 z1= 2 -.145159981269612E-05 0.000000000000000E+00 z1= 3 0.619295188684560E-01 0.000000000000000E+00 alpha(00000050)=0.000000000000000E+00 beta (00000051)=0.126967578195664E+02 gamma(00000051)=0.126967578195664E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 51 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000051)=0.000000000000000E+00 beta (00000052)=0.132891101660509E+02 gamma(00000052)=0.132891101660509E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 52 z1= 1 -.376125630565153E-06 0.000000000000000E+00 z1= 2 0.143060252097026E-05 0.000000000000000E+00 z1= 3 -.582338937991711E-01 0.000000000000000E+00 alpha(00000052)=0.000000000000000E+00 beta (00000053)=0.127443381051993E+02 gamma(00000053)=0.127443381051993E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 53 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000053)=0.000000000000000E+00 beta (00000054)=0.133131454589309E+02 gamma(00000054)=0.133131454589309E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 54 z1= 1 0.386800459106014E-06 0.000000000000000E+00 z1= 2 -.141725972719936E-05 0.000000000000000E+00 z1= 3 0.549116821518537E-01 0.000000000000000E+00 alpha(00000054)=0.000000000000000E+00 beta (00000055)=0.127443555249114E+02 gamma(00000055)=0.127443555249114E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 55 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000055)=0.000000000000000E+00 beta (00000056)=0.133785356211157E+02 gamma(00000056)=0.133785356211157E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 56 z1= 1 -.387040627415299E-06 0.000000000000000E+00 z1= 2 0.140519834988318E-05 0.000000000000000E+00 z1= 3 -.515464356968208E-01 0.000000000000000E+00 alpha(00000056)=0.000000000000000E+00 beta (00000057)=0.128320521691373E+02 gamma(00000057)=0.128320521691373E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 57 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000057)=0.000000000000000E+00 beta (00000058)=0.134459831606441E+02 gamma(00000058)=0.134459831606441E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 58 z1= 1 0.390204114986809E-06 0.000000000000000E+00 z1= 2 -.139598460212201E-05 0.000000000000000E+00 z1= 3 0.484734831516015E-01 0.000000000000000E+00 alpha(00000058)=0.000000000000000E+00 beta (00000059)=0.127464099486932E+02 gamma(00000059)=0.127464099486932E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 59 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000059)=0.000000000000000E+00 beta (00000060)=0.133328214749923E+02 gamma(00000060)=0.133328214749923E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 60 z1= 1 -.401214181003145E-06 0.000000000000000E+00 z1= 2 0.138719729284302E-05 0.000000000000000E+00 z1= 3 -.457064196602605E-01 0.000000000000000E+00 alpha(00000060)=0.000000000000000E+00 beta (00000061)=0.128405781829885E+02 gamma(00000061)=0.128405781829885E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 61 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000061)=0.000000000000000E+00 beta (00000062)=0.133760314070602E+02 gamma(00000062)=0.133760314070602E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 62 z1= 1 0.409863523079257E-06 0.000000000000000E+00 z1= 2 -.138483409732701E-05 0.000000000000000E+00 z1= 3 0.432740700417830E-01 0.000000000000000E+00 alpha(00000062)=0.000000000000000E+00 beta (00000063)=0.128441813063261E+02 gamma(00000063)=0.128441813063261E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 63 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000063)=0.000000000000000E+00 beta (00000064)=0.134459529144216E+02 gamma(00000064)=0.134459529144216E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 64 z1= 1 -.411269645499471E-06 0.000000000000000E+00 z1= 2 0.137674803435417E-05 0.000000000000000E+00 z1= 3 -.408088548818853E-01 0.000000000000000E+00 alpha(00000064)=0.000000000000000E+00 beta (00000065)=0.128237659503222E+02 gamma(00000065)=0.128237659503222E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 65 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000065)=0.000000000000000E+00 beta (00000066)=0.134804262353909E+02 gamma(00000066)=0.134804262353909E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 66 z1= 1 0.407175069250016E-06 0.000000000000000E+00 z1= 2 -.136587456575263E-05 0.000000000000000E+00 z1= 3 0.383603605599958E-01 0.000000000000000E+00 alpha(00000066)=0.000000000000000E+00 beta (00000067)=0.128621045321382E+02 gamma(00000067)=0.128621045321382E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 67 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000067)=0.000000000000000E+00 beta (00000068)=0.133881819731300E+02 gamma(00000068)=0.133881819731300E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 68 z1= 1 -.409205092595402E-06 0.000000000000000E+00 z1= 2 0.136796547267409E-05 0.000000000000000E+00 z1= 3 -.364115422872864E-01 0.000000000000000E+00 alpha(00000068)=0.000000000000000E+00 beta (00000069)=0.128152871979624E+02 gamma(00000069)=0.128152871979624E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 69 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000069)=0.000000000000000E+00 beta (00000070)=0.133445169394919E+02 gamma(00000070)=0.133445169394919E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 70 z1= 1 0.411971292148456E-06 0.000000000000000E+00 z1= 2 -.137035001564320E-05 0.000000000000000E+00 z1= 3 0.345813400894536E-01 0.000000000000000E+00 alpha(00000070)=0.000000000000000E+00 beta (00000071)=0.128069664250304E+02 gamma(00000071)=0.128069664250304E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 71 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000071)=0.000000000000000E+00 beta (00000072)=0.134042186544998E+02 gamma(00000072)=0.134042186544998E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 72 z1= 1 -.408660603338227E-06 0.000000000000000E+00 z1= 2 0.137762322212505E-05 0.000000000000000E+00 z1= 3 -.326970334696585E-01 0.000000000000000E+00 alpha(00000072)=0.000000000000000E+00 beta (00000073)=0.128627085061726E+02 gamma(00000073)=0.128627085061726E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 73 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000073)=0.000000000000000E+00 beta (00000074)=0.133230457670377E+02 gamma(00000074)=0.133230457670377E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 74 z1= 1 0.401753775790725E-06 0.000000000000000E+00 z1= 2 -.139084960749187E-05 0.000000000000000E+00 z1= 3 0.313039437789456E-01 0.000000000000000E+00 alpha(00000074)=0.000000000000000E+00 beta (00000075)=0.127141910649933E+02 gamma(00000075)=0.127141910649933E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 75 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000075)=0.000000000000000E+00 beta (00000076)=0.133868811025778E+02 gamma(00000076)=0.133868811025778E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 76 z1= 1 -.388509971943943E-06 0.000000000000000E+00 z1= 2 0.138194001259636E-05 0.000000000000000E+00 z1= 3 -.294640154357549E-01 0.000000000000000E+00 alpha(00000076)=0.000000000000000E+00 beta (00000077)=0.127641729481324E+02 gamma(00000077)=0.127641729481324E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 77 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000077)=0.000000000000000E+00 beta (00000078)=0.133755132283520E+02 gamma(00000078)=0.133755132283520E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 78 z1= 1 0.375629516454097E-06 0.000000000000000E+00 z1= 2 -.138137834489334E-05 0.000000000000000E+00 z1= 3 0.278749663002037E-01 0.000000000000000E+00 alpha(00000078)=0.000000000000000E+00 beta (00000079)=0.128262826897066E+02 gamma(00000079)=0.128262826897066E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 79 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000079)=0.000000000000000E+00 beta (00000080)=0.133316320024586E+02 gamma(00000080)=0.133316320024586E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 80 z1= 1 -.369271558708093E-06 0.000000000000000E+00 z1= 2 0.138882311198862E-05 0.000000000000000E+00 z1= 3 -.266563623741722E-01 0.000000000000000E+00 alpha(00000080)=0.000000000000000E+00 beta (00000081)=0.127857300683316E+02 gamma(00000081)=0.127857300683316E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 81 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000081)=0.000000000000000E+00 beta (00000082)=0.133994468312798E+02 gamma(00000082)=0.133994468312798E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 82 z1= 1 0.371447025596431E-06 0.000000000000000E+00 z1= 2 -.138006940424298E-05 0.000000000000000E+00 z1= 3 0.253068748144162E-01 0.000000000000000E+00 alpha(00000082)=0.000000000000000E+00 beta (00000083)=0.128396974756363E+02 gamma(00000083)=0.128396974756363E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 83 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000083)=0.000000000000000E+00 beta (00000084)=0.133717673234352E+02 gamma(00000084)=0.133717673234352E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 84 z1= 1 -.374363170708601E-06 0.000000000000000E+00 z1= 2 0.139771086234031E-05 0.000000000000000E+00 z1= 3 -.241734755116356E-01 0.000000000000000E+00 alpha(00000084)=0.000000000000000E+00 beta (00000085)=0.128117711412726E+02 gamma(00000085)=0.128117711412726E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 85 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000085)=0.000000000000000E+00 beta (00000086)=0.133218196445265E+02 gamma(00000086)=0.133218196445265E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 86 z1= 1 0.372583501667776E-06 0.000000000000000E+00 z1= 2 -.140893756512132E-05 0.000000000000000E+00 z1= 3 0.231494824799265E-01 0.000000000000000E+00 alpha(00000086)=0.000000000000000E+00 beta (00000087)=0.127545854398070E+02 gamma(00000087)=0.127545854398070E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 87 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000087)=0.000000000000000E+00 beta (00000088)=0.133435650534969E+02 gamma(00000088)=0.133435650534969E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 88 z1= 1 -.376393157562778E-06 0.000000000000000E+00 z1= 2 0.142932462921156E-05 0.000000000000000E+00 z1= 3 -.220546808921436E-01 0.000000000000000E+00 alpha(00000088)=0.000000000000000E+00 beta (00000089)=0.128929928338142E+02 gamma(00000089)=0.128929928338142E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 89 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000089)=0.000000000000000E+00 beta (00000090)=0.133924415621663E+02 gamma(00000090)=0.133924415621663E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 90 z1= 1 0.379767055989910E-06 0.000000000000000E+00 z1= 2 -.145123236055644E-05 0.000000000000000E+00 z1= 3 0.211836885420150E-01 0.000000000000000E+00 alpha(00000090)=0.000000000000000E+00 beta (00000091)=0.126659708940546E+02 gamma(00000091)=0.126659708940546E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 91 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000091)=0.000000000000000E+00 beta (00000092)=0.133458549987805E+02 gamma(00000092)=0.133458549987805E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 92 z1= 1 -.379719018033702E-06 0.000000000000000E+00 z1= 2 0.143193023750224E-05 0.000000000000000E+00 z1= 3 -.200867510875213E-01 0.000000000000000E+00 alpha(00000092)=0.000000000000000E+00 beta (00000093)=0.127909353894367E+02 gamma(00000093)=0.127909353894367E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 93 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000093)=0.000000000000000E+00 beta (00000094)=0.133461392367672E+02 gamma(00000094)=0.133461392367672E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 94 z1= 1 0.381773205322721E-06 0.000000000000000E+00 z1= 2 -.142332721228642E-05 0.000000000000000E+00 z1= 3 0.192793575825157E-01 0.000000000000000E+00 alpha(00000094)=0.000000000000000E+00 beta (00000095)=0.127865756137354E+02 gamma(00000095)=0.127865756137354E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 95 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000095)=0.000000000000000E+00 beta (00000096)=0.133901047924911E+02 gamma(00000096)=0.133901047924911E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 96 z1= 1 -.382127201856847E-06 0.000000000000000E+00 z1= 2 0.140675853523974E-05 0.000000000000000E+00 z1= 3 -.184173546151282E-01 0.000000000000000E+00 alpha(00000096)=0.000000000000000E+00 beta (00000097)=0.127921015489387E+02 gamma(00000097)=0.127921015489387E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 97 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000097)=0.000000000000000E+00 beta (00000098)=0.134509405706367E+02 gamma(00000098)=0.134509405706367E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 98 z1= 1 0.373403145351647E-06 0.000000000000000E+00 z1= 2 -.138281054593383E-05 0.000000000000000E+00 z1= 3 0.175095013450648E-01 0.000000000000000E+00 alpha(00000098)=0.000000000000000E+00 beta (00000099)=0.130150712798412E+02 gamma(00000099)=0.130150712798412E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 99 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000099)=0.000000000000000E+00 beta (00000100)=0.136149151643500E+02 gamma(00000100)=0.136149151643500E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 100 z1= 1 -.363954833079651E-06 0.000000000000000E+00 z1= 2 0.135140212272154E-05 0.000000000000000E+00 z1= 3 -.167551035958508E-01 0.000000000000000E+00 alpha(00000100)=0.000000000000000E+00 beta (00000101)=0.127969537798584E+02 gamma(00000101)=0.127969537798584E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 101 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000101)=0.000000000000000E+00 beta (00000102)=0.132882519555075E+02 gamma(00000102)=0.132882519555075E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 102 z1= 1 0.353242925780323E-06 0.000000000000000E+00 z1= 2 -.132540844692509E-05 0.000000000000000E+00 z1= 3 0.161802296489767E-01 0.000000000000000E+00 alpha(00000102)=0.000000000000000E+00 beta (00000103)=0.128815668818400E+02 gamma(00000103)=0.128815668818400E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 103 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000103)=0.000000000000000E+00 beta (00000104)=0.134147777072236E+02 gamma(00000104)=0.134147777072236E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 104 z1= 1 -.336068700878081E-06 0.000000000000000E+00 z1= 2 0.130035026413831E-05 0.000000000000000E+00 z1= 3 -.156277973105765E-01 0.000000000000000E+00 alpha(00000104)=0.000000000000000E+00 beta (00000105)=0.128778615642414E+02 gamma(00000105)=0.128778615642414E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 105 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000105)=0.000000000000000E+00 beta (00000106)=0.132659081263002E+02 gamma(00000106)=0.132659081263002E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 106 z1= 1 0.327013289379958E-06 0.000000000000000E+00 z1= 2 -.129753999506975E-05 0.000000000000000E+00 z1= 3 0.152723399666019E-01 0.000000000000000E+00 alpha(00000106)=0.000000000000000E+00 beta (00000107)=0.126949443075630E+02 gamma(00000107)=0.126949443075630E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 107 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000107)=0.000000000000000E+00 beta (00000108)=0.133395860015522E+02 gamma(00000108)=0.133395860015522E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 108 z1= 1 -.308018078545142E-06 0.000000000000000E+00 z1= 2 0.126921008255067E-05 0.000000000000000E+00 z1= 3 -.145903650463620E-01 0.000000000000000E+00 alpha(00000108)=0.000000000000000E+00 beta (00000109)=0.128482705661396E+02 gamma(00000109)=0.128482705661396E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 109 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000109)=0.000000000000000E+00 beta (00000110)=0.133217711669384E+02 gamma(00000110)=0.133217711669384E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 110 z1= 1 0.283648459603245E-06 0.000000000000000E+00 z1= 2 -.124051543318968E-05 0.000000000000000E+00 z1= 3 0.141248766320469E-01 0.000000000000000E+00 alpha(00000110)=0.000000000000000E+00 beta (00000111)=0.126967061895085E+02 gamma(00000111)=0.126967061895085E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 111 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000111)=0.000000000000000E+00 beta (00000112)=0.135206935220494E+02 gamma(00000112)=0.135206935220494E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 112 z1= 1 -.256864003219195E-06 0.000000000000000E+00 z1= 2 0.118176854277090E-05 0.000000000000000E+00 z1= 3 -.133230978099493E-01 0.000000000000000E+00 alpha(00000112)=0.000000000000000E+00 beta (00000113)=0.129787454282089E+02 gamma(00000113)=0.129787454282089E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 113 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000113)=0.000000000000000E+00 beta (00000114)=0.134372012459742E+02 gamma(00000114)=0.134372012459742E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 114 z1= 1 0.244636859705861E-06 0.000000000000000E+00 z1= 2 -.115227036997167E-05 0.000000000000000E+00 z1= 3 0.129013752388221E-01 0.000000000000000E+00 alpha(00000114)=0.000000000000000E+00 beta (00000115)=0.127033496681572E+02 gamma(00000115)=0.127033496681572E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 115 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000115)=0.000000000000000E+00 beta (00000116)=0.135069865158704E+02 gamma(00000116)=0.135069865158704E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 116 z1= 1 -.219912628478952E-06 0.000000000000000E+00 z1= 2 0.108452654905682E-05 0.000000000000000E+00 z1= 3 -.122157825431331E-01 0.000000000000000E+00 alpha(00000116)=0.000000000000000E+00 beta (00000117)=0.127083383061776E+02 gamma(00000117)=0.127083383061776E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 117 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000117)=0.000000000000000E+00 beta (00000118)=0.132506521961417E+02 gamma(00000118)=0.132506521961417E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 118 z1= 1 0.200016961818294E-06 0.000000000000000E+00 z1= 2 -.103772241404358E-05 0.000000000000000E+00 z1= 3 0.118300356893247E-01 0.000000000000000E+00 alpha(00000118)=0.000000000000000E+00 beta (00000119)=0.127948297849974E+02 gamma(00000119)=0.127948297849974E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 119 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000119)=0.000000000000000E+00 beta (00000120)=0.133198414949376E+02 gamma(00000120)=0.133198414949376E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 120 z1= 1 -.179696860330453E-06 0.000000000000000E+00 z1= 2 0.995052870292345E-06 0.000000000000000E+00 z1= 3 -.114618197098762E-01 0.000000000000000E+00 alpha(00000120)=0.000000000000000E+00 beta (00000121)=0.125251037201406E+02 gamma(00000121)=0.125251037201406E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 121 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000121)=0.000000000000000E+00 beta (00000122)=0.131931004350965E+02 gamma(00000122)=0.131931004350965E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 122 z1= 1 0.157050003878187E-06 0.000000000000000E+00 z1= 2 -.936636090655130E-06 0.000000000000000E+00 z1= 3 0.109870704163155E-01 0.000000000000000E+00 alpha(00000122)=0.000000000000000E+00 beta (00000123)=0.127053179605588E+02 gamma(00000123)=0.127053179605588E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 123 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000123)=0.000000000000000E+00 beta (00000124)=0.133819583568168E+02 gamma(00000124)=0.133819583568168E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 124 z1= 1 -.145357734462014E-06 0.000000000000000E+00 z1= 2 0.868061269802714E-06 0.000000000000000E+00 z1= 3 -.105066557291688E-01 0.000000000000000E+00 alpha(00000124)=0.000000000000000E+00 beta (00000125)=0.126842085207324E+02 gamma(00000125)=0.126842085207324E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 125 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000125)=0.000000000000000E+00 beta (00000126)=0.133805649366138E+02 gamma(00000126)=0.133805649366138E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 126 z1= 1 0.130462991909094E-06 0.000000000000000E+00 z1= 2 -.800554829065415E-06 0.000000000000000E+00 z1= 3 0.100410644616621E-01 0.000000000000000E+00 alpha(00000126)=0.000000000000000E+00 beta (00000127)=0.128061227389666E+02 gamma(00000127)=0.128061227389666E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 127 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000127)=0.000000000000000E+00 beta (00000128)=0.132907868245130E+02 gamma(00000128)=0.132907868245130E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 128 z1= 1 -.108976730496633E-06 0.000000000000000E+00 z1= 2 0.745894295548931E-06 0.000000000000000E+00 z1= 3 -.973689132445747E-02 0.000000000000000E+00 alpha(00000128)=0.000000000000000E+00 beta (00000129)=0.127747959183102E+02 gamma(00000129)=0.127747959183102E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 129 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000129)=0.000000000000000E+00 beta (00000130)=0.132951242339266E+02 gamma(00000130)=0.132951242339266E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 130 z1= 1 0.920587140817043E-07 0.000000000000000E+00 z1= 2 -.677405282911215E-06 0.000000000000000E+00 z1= 3 0.941492002019327E-02 0.000000000000000E+00 alpha(00000130)=0.000000000000000E+00 beta (00000131)=0.127446363909353E+02 gamma(00000131)=0.127446363909353E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 131 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000131)=0.000000000000000E+00 beta (00000132)=0.131433407621370E+02 gamma(00000132)=0.131433407621370E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 132 z1= 1 -.716042326161237E-07 0.000000000000000E+00 z1= 2 0.604217574758906E-06 0.000000000000000E+00 z1= 3 -.917833925590113E-02 0.000000000000000E+00 alpha(00000132)=0.000000000000000E+00 beta (00000133)=0.127576269161865E+02 gamma(00000133)=0.127576269161865E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 133 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000133)=0.000000000000000E+00 beta (00000134)=0.134670396248101E+02 gamma(00000134)=0.134670396248101E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 134 z1= 1 0.500940044599520E-07 0.000000000000000E+00 z1= 2 -.518604529950158E-06 0.000000000000000E+00 z1= 3 0.869379152367554E-02 0.000000000000000E+00 alpha(00000134)=0.000000000000000E+00 beta (00000135)=0.127762096765290E+02 gamma(00000135)=0.127762096765290E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 135 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000135)=0.000000000000000E+00 beta (00000136)=0.134260243123721E+02 gamma(00000136)=0.134260243123721E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 136 z1= 1 -.282748881853551E-07 0.000000000000000E+00 z1= 2 0.433753171752383E-06 0.000000000000000E+00 z1= 3 -.830339421216032E-02 0.000000000000000E+00 alpha(00000136)=0.000000000000000E+00 beta (00000137)=0.129114138411252E+02 gamma(00000137)=0.129114138411252E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 137 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000137)=0.000000000000000E+00 beta (00000138)=0.133836428113206E+02 gamma(00000138)=0.133836428113206E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 138 z1= 1 0.210099656530911E-08 0.000000000000000E+00 z1= 2 -.364009318607747E-06 0.000000000000000E+00 z1= 3 0.809097097954074E-02 0.000000000000000E+00 alpha(00000138)=0.000000000000000E+00 beta (00000139)=0.129445226704384E+02 gamma(00000139)=0.129445226704384E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 139 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000139)=0.000000000000000E+00 beta (00000140)=0.135471024985667E+02 gamma(00000140)=0.135471024985667E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 140 z1= 1 0.154140975646344E-07 0.000000000000000E+00 z1= 2 0.296632525290797E-06 0.000000000000000E+00 z1= 3 -.782250478209451E-02 0.000000000000000E+00 alpha(00000140)=0.000000000000000E+00 beta (00000141)=0.127278446741130E+02 gamma(00000141)=0.127278446741130E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 141 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000141)=0.000000000000000E+00 beta (00000142)=0.134909264708063E+02 gamma(00000142)=0.134909264708063E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 142 z1= 1 -.426478923307248E-07 0.000000000000000E+00 z1= 2 -.211168451976613E-06 0.000000000000000E+00 z1= 3 0.747283926774506E-02 0.000000000000000E+00 alpha(00000142)=0.000000000000000E+00 beta (00000143)=0.127388148861879E+02 gamma(00000143)=0.127388148861879E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 143 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000143)=0.000000000000000E+00 beta (00000144)=0.134409885814349E+02 gamma(00000144)=0.134409885814349E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 144 z1= 1 0.747484597842484E-07 0.000000000000000E+00 z1= 2 0.144201699034879E-06 0.000000000000000E+00 z1= 3 -.715012006305781E-02 0.000000000000000E+00 alpha(00000144)=0.000000000000000E+00 beta (00000145)=0.129263333353800E+02 gamma(00000145)=0.129263333353800E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 145 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000145)=0.000000000000000E+00 beta (00000146)=0.133955255823472E+02 gamma(00000146)=0.133955255823472E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 146 z1= 1 -.106416011726954E-06 0.000000000000000E+00 z1= 2 -.825984373834052E-07 0.000000000000000E+00 z1= 3 0.694954061214565E-02 0.000000000000000E+00 alpha(00000146)=0.000000000000000E+00 beta (00000147)=0.128294728964879E+02 gamma(00000147)=0.128294728964879E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 147 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000147)=0.000000000000000E+00 beta (00000148)=0.136375244342276E+02 gamma(00000148)=0.136375244342276E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 148 z1= 1 0.143486239325254E-06 0.000000000000000E+00 z1= 2 0.312285877524052E-07 0.000000000000000E+00 z1= 3 -.656989240948941E-02 0.000000000000000E+00 alpha(00000148)=0.000000000000000E+00 beta (00000149)=0.127202999421697E+02 gamma(00000149)=0.127202999421697E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 149 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000149)=0.000000000000000E+00 beta (00000150)=0.135407524599554E+02 gamma(00000150)=0.135407524599554E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 150 z1= 1 -.176464841550512E-06 0.000000000000000E+00 z1= 2 0.294639030420886E-07 0.000000000000000E+00 z1= 3 0.618160732530675E-02 0.000000000000000E+00 alpha(00000150)=0.000000000000000E+00 beta (00000151)=0.126679029120049E+02 gamma(00000151)=0.126679029120049E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 151 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000151)=0.000000000000000E+00 beta (00000152)=0.134957589029234E+02 gamma(00000152)=0.134957589029234E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 152 z1= 1 0.207635163850233E-06 0.000000000000000E+00 z1= 2 -.828628765221773E-07 0.000000000000000E+00 z1= 3 -.579888942995532E-02 0.000000000000000E+00 alpha(00000152)=0.000000000000000E+00 beta (00000153)=0.125471926645662E+02 gamma(00000153)=0.125471926645662E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 153 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000153)=0.000000000000000E+00 beta (00000154)=0.132884937185102E+02 gamma(00000154)=0.132884937185102E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 154 z1= 1 -.241500095632115E-06 0.000000000000000E+00 z1= 2 0.142512180870049E-06 0.000000000000000E+00 z1= 3 0.545223355858780E-02 0.000000000000000E+00 alpha(00000154)=0.000000000000000E+00 beta (00000155)=0.128413078290597E+02 gamma(00000155)=0.128413078290597E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 155 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000155)=0.000000000000000E+00 beta (00000156)=0.133879541207903E+02 gamma(00000156)=0.133879541207903E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 156 z1= 1 0.269820176843224E-06 0.000000000000000E+00 z1= 2 -.195535615146129E-06 0.000000000000000E+00 z1= 3 -.518984216730662E-02 0.000000000000000E+00 alpha(00000156)=0.000000000000000E+00 beta (00000157)=0.128086777078369E+02 gamma(00000157)=0.128086777078369E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 157 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000157)=0.000000000000000E+00 beta (00000158)=0.135343396812008E+02 gamma(00000158)=0.135343396812008E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 158 z1= 1 -.298275948794335E-06 0.000000000000000E+00 z1= 2 0.248966304255581E-06 0.000000000000000E+00 z1= 3 0.482114624317746E-02 0.000000000000000E+00 alpha(00000158)=0.000000000000000E+00 beta (00000159)=0.127047568736182E+02 gamma(00000159)=0.127047568736182E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 159 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000159)=0.000000000000000E+00 beta (00000160)=0.132659525194084E+02 gamma(00000160)=0.132659525194084E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 160 z1= 1 0.326041822706034E-06 0.000000000000000E+00 z1= 2 -.313547989584098E-06 0.000000000000000E+00 z1= 3 -.451845186124902E-02 0.000000000000000E+00 alpha(00000160)=0.000000000000000E+00 beta (00000161)=0.125635456867439E+02 gamma(00000161)=0.125635456867439E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 161 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000161)=0.000000000000000E+00 beta (00000162)=0.133039633284584E+02 gamma(00000162)=0.133039633284584E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 162 z1= 1 -.341117347757002E-06 0.000000000000000E+00 z1= 2 0.380000502966585E-06 0.000000000000000E+00 z1= 3 0.423000653483744E-02 0.000000000000000E+00 alpha(00000162)=0.000000000000000E+00 beta (00000163)=0.127495020522159E+02 gamma(00000163)=0.127495020522159E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 163 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000163)=0.000000000000000E+00 beta (00000164)=0.131751256591847E+02 gamma(00000164)=0.131751256591847E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 164 z1= 1 0.358750322765432E-06 0.000000000000000E+00 z1= 2 -.447155730302288E-06 0.000000000000000E+00 z1= 3 -.411031749346049E-02 0.000000000000000E+00 alpha(00000164)=0.000000000000000E+00 beta (00000165)=0.126038904677211E+02 gamma(00000165)=0.126038904677211E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 165 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000165)=0.000000000000000E+00 beta (00000166)=0.134358653971800E+02 gamma(00000166)=0.134358653971800E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 166 z1= 1 -.363865760978638E-06 0.000000000000000E+00 z1= 2 0.491400649710164E-06 0.000000000000000E+00 z1= 3 0.389753150249627E-02 0.000000000000000E+00 alpha(00000166)=0.000000000000000E+00 beta (00000167)=0.127184584998628E+02 gamma(00000167)=0.127184584998628E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 167 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000167)=0.000000000000000E+00 beta (00000168)=0.134466489192027E+02 gamma(00000168)=0.134466489192027E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 168 z1= 1 0.375224016277962E-06 0.000000000000000E+00 z1= 2 -.530232530982286E-06 0.000000000000000E+00 z1= 3 -.379403085737479E-02 0.000000000000000E+00 alpha(00000168)=0.000000000000000E+00 beta (00000169)=0.127723884691224E+02 gamma(00000169)=0.127723884691224E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 169 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000169)=0.000000000000000E+00 beta (00000170)=0.132923318105464E+02 gamma(00000170)=0.132923318105464E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 170 z1= 1 -.391443385787480E-06 0.000000000000000E+00 z1= 2 0.577785297559461E-06 0.000000000000000E+00 z1= 3 0.375438362727501E-02 0.000000000000000E+00 alpha(00000170)=0.000000000000000E+00 beta (00000171)=0.127568566893478E+02 gamma(00000171)=0.127568566893478E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 171 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000171)=0.000000000000000E+00 beta (00000172)=0.133681883094181E+02 gamma(00000172)=0.133681883094181E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 172 z1= 1 0.411371150653038E-06 0.000000000000000E+00 z1= 2 -.634873761258612E-06 0.000000000000000E+00 z1= 3 -.371256942782182E-02 0.000000000000000E+00 alpha(00000172)=0.000000000000000E+00 beta (00000173)=0.127960417302967E+02 gamma(00000173)=0.127960417302967E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 173 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000173)=0.000000000000000E+00 beta (00000174)=0.134741900471903E+02 gamma(00000174)=0.134741900471903E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 174 z1= 1 -.421300142582813E-06 0.000000000000000E+00 z1= 2 0.681455693916537E-06 0.000000000000000E+00 z1= 3 0.357095407250748E-02 0.000000000000000E+00 alpha(00000174)=0.000000000000000E+00 beta (00000175)=0.128361178481879E+02 gamma(00000175)=0.128361178481879E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 175 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000175)=0.000000000000000E+00 beta (00000176)=0.133955772904282E+02 gamma(00000176)=0.133955772904282E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 176 z1= 1 0.437586844400327E-06 0.000000000000000E+00 z1= 2 -.739431561178728E-06 0.000000000000000E+00 z1= 3 -.335493395881408E-02 0.000000000000000E+00 alpha(00000176)=0.000000000000000E+00 beta (00000177)=0.127371820873151E+02 gamma(00000177)=0.127371820873151E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 177 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000177)=0.000000000000000E+00 beta (00000178)=0.133609367412272E+02 gamma(00000178)=0.133609367412272E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 178 z1= 1 -.455401051569973E-06 0.000000000000000E+00 z1= 2 0.791255630966630E-06 0.000000000000000E+00 z1= 3 0.312199236370041E-02 0.000000000000000E+00 alpha(00000178)=0.000000000000000E+00 beta (00000179)=0.126228648204348E+02 gamma(00000179)=0.126228648204348E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 179 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000179)=0.000000000000000E+00 beta (00000180)=0.134189388232718E+02 gamma(00000180)=0.134189388232718E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 180 z1= 1 0.470850843370694E-06 0.000000000000000E+00 z1= 2 -.847009135181652E-06 0.000000000000000E+00 z1= 3 -.280504011437932E-02 0.000000000000000E+00 alpha(00000180)=0.000000000000000E+00 beta (00000181)=0.127642324869603E+02 gamma(00000181)=0.127642324869603E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 181 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000181)=0.000000000000000E+00 beta (00000182)=0.134409155381448E+02 gamma(00000182)=0.134409155381448E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 182 z1= 1 -.495732831673479E-06 0.000000000000000E+00 z1= 2 0.910779302113173E-06 0.000000000000000E+00 z1= 3 0.252769582888933E-02 0.000000000000000E+00 alpha(00000182)=0.000000000000000E+00 beta (00000183)=0.128179032870292E+02 gamma(00000183)=0.128179032870292E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 183 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000183)=0.000000000000000E+00 beta (00000184)=0.135090379866188E+02 gamma(00000184)=0.135090379866188E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 184 z1= 1 0.506313380926621E-06 0.000000000000000E+00 z1= 2 -.984229772027783E-06 0.000000000000000E+00 z1= 3 -.229157542438511E-02 0.000000000000000E+00 alpha(00000184)=0.000000000000000E+00 beta (00000185)=0.129152257419814E+02 gamma(00000185)=0.129152257419814E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 185 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000185)=0.000000000000000E+00 beta (00000186)=0.133109443733883E+02 gamma(00000186)=0.133109443733883E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 186 z1= 1 -.524543938966524E-06 0.000000000000000E+00 z1= 2 0.107143643765241E-05 0.000000000000000E+00 z1= 3 0.208359555710289E-02 0.000000000000000E+00 alpha(00000186)=0.000000000000000E+00 beta (00000187)=0.127266789412962E+02 gamma(00000187)=0.127266789412962E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 187 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000187)=0.000000000000000E+00 beta (00000188)=0.134537882668055E+02 gamma(00000188)=0.134537882668055E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 188 z1= 1 0.531954343362798E-06 0.000000000000000E+00 z1= 2 -.113341419523476E-05 0.000000000000000E+00 z1= 3 -.185796104338828E-02 0.000000000000000E+00 alpha(00000188)=0.000000000000000E+00 beta (00000189)=0.129513184374789E+02 gamma(00000189)=0.129513184374789E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 189 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000189)=0.000000000000000E+00 beta (00000190)=0.137067231672941E+02 gamma(00000190)=0.137067231672941E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 190 z1= 1 -.531471382116987E-06 0.000000000000000E+00 z1= 2 0.116532745453107E-05 0.000000000000000E+00 z1= 3 0.163472147117292E-02 0.000000000000000E+00 alpha(00000190)=0.000000000000000E+00 beta (00000191)=0.128651888494620E+02 gamma(00000191)=0.128651888494620E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 191 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000191)=0.000000000000000E+00 beta (00000192)=0.134373747764514E+02 gamma(00000192)=0.134373747764514E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 192 z1= 1 0.542032768081592E-06 0.000000000000000E+00 z1= 2 -.121409514990936E-05 0.000000000000000E+00 z1= 3 -.143887773699323E-02 0.000000000000000E+00 alpha(00000192)=0.000000000000000E+00 beta (00000193)=0.127839033456557E+02 gamma(00000193)=0.127839033456557E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 193 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000193)=0.000000000000000E+00 beta (00000194)=0.131981242319597E+02 gamma(00000194)=0.131981242319597E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 194 z1= 1 -.554376804885628E-06 0.000000000000000E+00 z1= 2 0.127172951957448E-05 0.000000000000000E+00 z1= 3 0.131551717073916E-02 0.000000000000000E+00 alpha(00000194)=0.000000000000000E+00 beta (00000195)=0.126839705637911E+02 gamma(00000195)=0.126839705637911E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 195 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000195)=0.000000000000000E+00 beta (00000196)=0.133139870616707E+02 gamma(00000196)=0.133139870616707E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 196 z1= 1 0.558486781600546E-06 0.000000000000000E+00 z1= 2 -.131997583286021E-05 0.000000000000000E+00 z1= 3 -.121598765817174E-02 0.000000000000000E+00 alpha(00000196)=0.000000000000000E+00 beta (00000197)=0.126079556710371E+02 gamma(00000197)=0.126079556710371E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 197 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000197)=0.000000000000000E+00 beta (00000198)=0.136343170438687E+02 gamma(00000198)=0.136343170438687E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 198 z1= 1 -.543820786502565E-06 0.000000000000000E+00 z1= 2 0.131330038152051E-05 0.000000000000000E+00 z1= 3 0.114361442906076E-02 0.000000000000000E+00 alpha(00000198)=0.000000000000000E+00 beta (00000199)=0.126706279852249E+02 gamma(00000199)=0.126706279852249E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 199 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000199)=0.000000000000000E+00 beta (00000200)=0.134978626881212E+02 gamma(00000200)=0.134978626881212E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 200 z1= 1 0.546122877799971E-06 0.000000000000000E+00 z1= 2 -.133728157675694E-05 0.000000000000000E+00 z1= 3 -.113919605987403E-02 0.000000000000000E+00 alpha(00000200)=0.000000000000000E+00 beta (00000201)=0.126143139102749E+02 gamma(00000201)=0.126143139102749E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 201 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000201)=0.000000000000000E+00 beta (00000202)=0.133826811062926E+02 gamma(00000202)=0.133826811062926E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 202 z1= 1 -.550805676898203E-06 0.000000000000000E+00 z1= 2 0.133621853515861E-05 0.000000000000000E+00 z1= 3 0.113993346498625E-02 0.000000000000000E+00 alpha(00000202)=0.000000000000000E+00 beta (00000203)=0.127737846541513E+02 gamma(00000203)=0.127737846541513E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 203 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000203)=0.000000000000000E+00 beta (00000204)=0.135575587079049E+02 gamma(00000204)=0.135575587079049E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 204 z1= 1 0.552442015003528E-06 0.000000000000000E+00 z1= 2 -.134429945664795E-05 0.000000000000000E+00 z1= 3 -.112070105984679E-02 0.000000000000000E+00 alpha(00000204)=0.000000000000000E+00 beta (00000205)=0.128450518769431E+02 gamma(00000205)=0.128450518769431E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 205 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000205)=0.000000000000000E+00 beta (00000206)=0.134791534801382E+02 gamma(00000206)=0.134791534801382E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 206 z1= 1 -.563934132017074E-06 0.000000000000000E+00 z1= 2 0.133887510243299E-05 0.000000000000000E+00 z1= 3 0.117526056168665E-02 0.000000000000000E+00 alpha(00000206)=0.000000000000000E+00 beta (00000207)=0.127620203992589E+02 gamma(00000207)=0.127620203992589E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 207 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000207)=0.000000000000000E+00 beta (00000208)=0.133839137319547E+02 gamma(00000208)=0.133839137319547E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 208 z1= 1 0.574977857099369E-06 0.000000000000000E+00 z1= 2 -.133677040462204E-05 0.000000000000000E+00 z1= 3 -.125150370437088E-02 0.000000000000000E+00 alpha(00000208)=0.000000000000000E+00 beta (00000209)=0.126287971377642E+02 gamma(00000209)=0.126287971377642E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 209 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000209)=0.000000000000000E+00 beta (00000210)=0.135242410449407E+02 gamma(00000210)=0.135242410449407E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 210 z1= 1 -.570969557827771E-06 0.000000000000000E+00 z1= 2 0.130803923326122E-05 0.000000000000000E+00 z1= 3 0.133352042792105E-02 0.000000000000000E+00 alpha(00000210)=0.000000000000000E+00 beta (00000211)=0.126503303340757E+02 gamma(00000211)=0.126503303340757E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 211 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000211)=0.000000000000000E+00 beta (00000212)=0.135864385904648E+02 gamma(00000212)=0.135864385904648E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 212 z1= 1 0.565673003581120E-06 0.000000000000000E+00 z1= 2 -.129390056143031E-05 0.000000000000000E+00 z1= 3 -.134124387012651E-02 0.000000000000000E+00 alpha(00000212)=0.000000000000000E+00 beta (00000213)=0.126859743538517E+02 gamma(00000213)=0.126859743538517E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 213 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000213)=0.000000000000000E+00 beta (00000214)=0.134727079869596E+02 gamma(00000214)=0.134727079869596E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 214 z1= 1 -.570099732002065E-06 0.000000000000000E+00 z1= 2 0.130798919853949E-05 0.000000000000000E+00 z1= 3 0.124212549145008E-02 0.000000000000000E+00 alpha(00000214)=0.000000000000000E+00 beta (00000215)=0.125567667102425E+02 gamma(00000215)=0.125567667102425E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 215 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000215)=0.000000000000000E+00 beta (00000216)=0.132488415349025E+02 gamma(00000216)=0.132488415349025E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 216 z1= 1 0.573717353576290E-06 0.000000000000000E+00 z1= 2 -.131334670388028E-05 0.000000000000000E+00 z1= 3 -.111934342658342E-02 0.000000000000000E+00 alpha(00000216)=0.000000000000000E+00 beta (00000217)=0.124624319349730E+02 gamma(00000217)=0.124624319349730E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 217 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000217)=0.000000000000000E+00 beta (00000218)=0.136513087510261E+02 gamma(00000218)=0.136513087510261E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 218 z1= 1 -.552099851272396E-06 0.000000000000000E+00 z1= 2 0.126684375601952E-05 0.000000000000000E+00 z1= 3 0.927208759252342E-03 0.000000000000000E+00 alpha(00000218)=0.000000000000000E+00 beta (00000219)=0.127274228748273E+02 gamma(00000219)=0.127274228748273E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 219 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000219)=0.000000000000000E+00 beta (00000220)=0.134287275413219E+02 gamma(00000220)=0.134287275413219E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 220 z1= 1 0.552327883041889E-06 0.000000000000000E+00 z1= 2 -.126552096700341E-05 0.000000000000000E+00 z1= 3 -.777015787753332E-03 0.000000000000000E+00 alpha(00000220)=0.000000000000000E+00 beta (00000221)=0.127703454805540E+02 gamma(00000221)=0.127703454805540E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 221 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000221)=0.000000000000000E+00 beta (00000222)=0.132933859257373E+02 gamma(00000222)=0.132933859257373E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 222 z1= 1 -.564789806963798E-06 0.000000000000000E+00 z1= 2 0.130812859536043E-05 0.000000000000000E+00 z1= 3 0.620872185668915E-03 0.000000000000000E+00 alpha(00000222)=0.000000000000000E+00 beta (00000223)=0.128282704186308E+02 gamma(00000223)=0.128282704186308E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 223 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000223)=0.000000000000000E+00 beta (00000224)=0.132058959439121E+02 gamma(00000224)=0.132058959439121E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 224 z1= 1 0.581375468775469E-06 0.000000000000000E+00 z1= 2 -.133523817385514E-05 0.000000000000000E+00 z1= 3 -.430580993013246E-03 0.000000000000000E+00 alpha(00000224)=0.000000000000000E+00 beta (00000225)=0.129770362601576E+02 gamma(00000225)=0.129770362601576E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 225 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000225)=0.000000000000000E+00 beta (00000226)=0.133541749785659E+02 gamma(00000226)=0.133541749785659E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 226 z1= 1 -.599147315333325E-06 0.000000000000000E+00 z1= 2 0.137374016239610E-05 0.000000000000000E+00 z1= 3 0.236438321236355E-03 0.000000000000000E+00 alpha(00000226)=0.000000000000000E+00 beta (00000227)=0.128225244354512E+02 gamma(00000227)=0.128225244354512E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 227 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000227)=0.000000000000000E+00 beta (00000228)=0.135109083731040E+02 gamma(00000228)=0.135109083731040E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 228 z1= 1 0.599089202466918E-06 0.000000000000000E+00 z1= 2 -.133796892961007E-05 0.000000000000000E+00 z1= 3 -.768885985542294E-04 0.000000000000000E+00 alpha(00000228)=0.000000000000000E+00 beta (00000229)=0.127024362018812E+02 gamma(00000229)=0.127024362018812E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 229 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000229)=0.000000000000000E+00 beta (00000230)=0.134491753117693E+02 gamma(00000230)=0.134491753117693E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 230 z1= 1 -.599330073211926E-06 0.000000000000000E+00 z1= 2 0.133962613777590E-05 0.000000000000000E+00 z1= 3 -.455511549428706E-04 0.000000000000000E+00 alpha(00000230)=0.000000000000000E+00 beta (00000231)=0.129123601870796E+02 gamma(00000231)=0.129123601870796E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 231 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000231)=0.000000000000000E+00 beta (00000232)=0.137268104071323E+02 gamma(00000232)=0.137268104071323E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 232 z1= 1 0.598242690109420E-06 0.000000000000000E+00 z1= 2 -.130937416151179E-05 0.000000000000000E+00 z1= 3 0.113477318406291E-03 0.000000000000000E+00 alpha(00000232)=0.000000000000000E+00 beta (00000233)=0.127781163459516E+02 gamma(00000233)=0.127781163459516E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 233 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000233)=0.000000000000000E+00 beta (00000234)=0.133503608862439E+02 gamma(00000234)=0.133503608862439E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 234 z1= 1 -.616493624310314E-06 0.000000000000000E+00 z1= 2 0.132113831547364E-05 0.000000000000000E+00 z1= 3 -.180097848624033E-03 0.000000000000000E+00 alpha(00000234)=0.000000000000000E+00 beta (00000235)=0.125911995627005E+02 gamma(00000235)=0.125911995627005E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 235 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000235)=0.000000000000000E+00 beta (00000236)=0.133931163382290E+02 gamma(00000236)=0.133931163382290E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 236 z1= 1 0.618472232832455E-06 0.000000000000000E+00 z1= 2 -.127838576309688E-05 0.000000000000000E+00 z1= 3 0.213778395855775E-03 0.000000000000000E+00 alpha(00000236)=0.000000000000000E+00 beta (00000237)=0.128915663637625E+02 gamma(00000237)=0.128915663637625E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 237 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000237)=0.000000000000000E+00 beta (00000238)=0.135197269058366E+02 gamma(00000238)=0.135197269058366E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 238 z1= 1 -.624748068315693E-06 0.000000000000000E+00 z1= 2 0.127059262056405E-05 0.000000000000000E+00 z1= 3 -.247498403681875E-03 0.000000000000000E+00 alpha(00000238)=0.000000000000000E+00 beta (00000239)=0.127636398943868E+02 gamma(00000239)=0.127636398943868E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 239 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000239)=0.000000000000000E+00 beta (00000240)=0.133597369963080E+02 gamma(00000240)=0.133597369963080E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 240 z1= 1 0.638986445368819E-06 0.000000000000000E+00 z1= 2 -.126376980639234E-05 0.000000000000000E+00 z1= 3 0.255295343547981E-03 0.000000000000000E+00 alpha(00000240)=0.000000000000000E+00 beta (00000241)=0.127491151141515E+02 gamma(00000241)=0.127491151141515E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 241 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000241)=0.000000000000000E+00 beta (00000242)=0.134028997093839E+02 gamma(00000242)=0.134028997093839E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 242 z1= 1 -.643583546281867E-06 0.000000000000000E+00 z1= 2 0.125292513722879E-05 0.000000000000000E+00 z1= 3 -.217520493399131E-03 0.000000000000000E+00 alpha(00000242)=0.000000000000000E+00 beta (00000243)=0.128892925646346E+02 gamma(00000243)=0.128892925646346E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 243 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000243)=0.000000000000000E+00 beta (00000244)=0.135139827227624E+02 gamma(00000244)=0.135139827227624E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 244 z1= 1 0.646958573288976E-06 0.000000000000000E+00 z1= 2 -.123568839233590E-05 0.000000000000000E+00 z1= 3 0.176642108764853E-03 0.000000000000000E+00 alpha(00000244)=0.000000000000000E+00 beta (00000245)=0.125465531289791E+02 gamma(00000245)=0.125465531289791E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 245 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000245)=0.000000000000000E+00 beta (00000246)=0.130511057384515E+02 gamma(00000246)=0.130511057384515E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 246 z1= 1 -.669068605404794E-06 0.000000000000000E+00 z1= 2 0.124275464801675E-05 0.000000000000000E+00 z1= 3 -.686764803304700E-04 0.000000000000000E+00 alpha(00000246)=0.000000000000000E+00 beta (00000247)=0.125672194218394E+02 gamma(00000247)=0.125672194218394E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 247 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000247)=0.000000000000000E+00 beta (00000248)=0.133322000903193E+02 gamma(00000248)=0.133322000903193E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 248 z1= 1 0.681577942250578E-06 0.000000000000000E+00 z1= 2 -.123381701972245E-05 0.000000000000000E+00 z1= 3 -.266689805971960E-04 0.000000000000000E+00 alpha(00000248)=0.000000000000000E+00 beta (00000249)=0.127880968096045E+02 gamma(00000249)=0.127880968096045E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 249 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000249)=0.000000000000000E+00 beta (00000250)=0.134565581046965E+02 gamma(00000250)=0.134565581046965E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 250 z1= 1 -.694963790836151E-06 0.000000000000000E+00 z1= 2 0.122023517276529E-05 0.000000000000000E+00 z1= 3 0.128802028552043E-03 0.000000000000000E+00 alpha(00000250)=0.000000000000000E+00 beta (00000251)=0.125503690253823E+02 gamma(00000251)=0.125503690253823E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 251 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000251)=0.000000000000000E+00 beta (00000252)=0.132840585916851E+02 gamma(00000252)=0.132840585916851E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 252 z1= 1 0.714218952106303E-06 0.000000000000000E+00 z1= 2 -.121037865157372E-05 0.000000000000000E+00 z1= 3 -.179274714231667E-03 0.000000000000000E+00 alpha(00000252)=0.000000000000000E+00 beta (00000253)=0.129336467496663E+02 gamma(00000253)=0.129336467496663E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 253 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000253)=0.000000000000000E+00 beta (00000254)=0.135149193239822E+02 gamma(00000254)=0.135149193239822E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 254 z1= 1 -.735231184990719E-06 0.000000000000000E+00 z1= 2 0.120195177215625E-05 0.000000000000000E+00 z1= 3 0.150988149145704E-03 0.000000000000000E+00 alpha(00000254)=0.000000000000000E+00 beta (00000255)=0.128019352131742E+02 gamma(00000255)=0.128019352131742E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 255 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000255)=0.000000000000000E+00 beta (00000256)=0.136716720200583E+02 gamma(00000256)=0.136716720200583E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 256 z1= 1 0.740090766522712E-06 0.000000000000000E+00 z1= 2 -.118564917640329E-05 0.000000000000000E+00 z1= 3 -.137059842599200E-03 0.000000000000000E+00 alpha(00000256)=0.000000000000000E+00 beta (00000257)=0.128300169711027E+02 gamma(00000257)=0.128300169711027E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 257 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000257)=0.000000000000000E+00 beta (00000258)=0.134221764225424E+02 gamma(00000258)=0.134221764225424E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 258 z1= 1 -.763114090801022E-06 0.000000000000000E+00 z1= 2 0.117708801347519E-05 0.000000000000000E+00 z1= 3 0.138314965273885E-03 0.000000000000000E+00 alpha(00000258)=0.000000000000000E+00 beta (00000259)=0.130324414893717E+02 gamma(00000259)=0.130324414893717E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 259 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000259)=0.000000000000000E+00 beta (00000260)=0.135340611114582E+02 gamma(00000260)=0.135340611114582E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 260 z1= 1 0.786494248650323E-06 0.000000000000000E+00 z1= 2 -.117528697542450E-05 0.000000000000000E+00 z1= 3 -.928929111123130E-04 0.000000000000000E+00 alpha(00000260)=0.000000000000000E+00 beta (00000261)=0.127717003129934E+02 gamma(00000261)=0.127717003129934E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 261 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000261)=0.000000000000000E+00 beta (00000262)=0.133221254906216E+02 gamma(00000262)=0.133221254906216E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 262 z1= 1 -.808548144851811E-06 0.000000000000000E+00 z1= 2 0.114094107089748E-05 0.000000000000000E+00 z1= 3 0.479945003352845E-04 0.000000000000000E+00 alpha(00000262)=0.000000000000000E+00 beta (00000263)=0.126369348152825E+02 gamma(00000263)=0.126369348152825E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 263 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000263)=0.000000000000000E+00 beta (00000264)=0.132587151044912E+02 gamma(00000264)=0.132587151044912E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 264 z1= 1 0.832728670075025E-06 0.000000000000000E+00 z1= 2 -.111459423533350E-05 0.000000000000000E+00 z1= 3 -.468145628130731E-05 0.000000000000000E+00 alpha(00000264)=0.000000000000000E+00 beta (00000265)=0.127327481978581E+02 gamma(00000265)=0.127327481978581E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 265 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000265)=0.000000000000000E+00 beta (00000266)=0.134480083555586E+02 gamma(00000266)=0.134480083555586E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 266 z1= 1 -.847673392096276E-06 0.000000000000000E+00 z1= 2 0.107591641115178E-05 0.000000000000000E+00 z1= 3 0.661403806914446E-05 0.000000000000000E+00 alpha(00000266)=0.000000000000000E+00 beta (00000267)=0.127991069567262E+02 gamma(00000267)=0.127991069567262E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 267 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000267)=0.000000000000000E+00 beta (00000268)=0.133509648125398E+02 gamma(00000268)=0.133509648125398E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 268 z1= 1 0.861293865518214E-06 0.000000000000000E+00 z1= 2 -.105054333559413E-05 0.000000000000000E+00 z1= 3 -.568672725593123E-04 0.000000000000000E+00 alpha(00000268)=0.000000000000000E+00 beta (00000269)=0.126159938733929E+02 gamma(00000269)=0.126159938733929E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 269 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000269)=0.000000000000000E+00 beta (00000270)=0.135207238563646E+02 gamma(00000270)=0.135207238563646E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 270 z1= 1 -.850933597511657E-06 0.000000000000000E+00 z1= 2 0.978869600185619E-06 0.000000000000000E+00 z1= 3 0.127265639789825E-03 0.000000000000000E+00 alpha(00000270)=0.000000000000000E+00 beta (00000271)=0.130324123235257E+02 gamma(00000271)=0.130324123235257E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 271 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000271)=0.000000000000000E+00 beta (00000272)=0.132956027752198E+02 gamma(00000272)=0.132956027752198E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 272 z1= 1 0.886784847518239E-06 0.000000000000000E+00 z1= 2 -.965208470624567E-06 0.000000000000000E+00 z1= 3 -.191859941941791E-03 0.000000000000000E+00 alpha(00000272)=0.000000000000000E+00 beta (00000273)=0.127269484826188E+02 gamma(00000273)=0.127269484826188E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 273 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000273)=0.000000000000000E+00 beta (00000274)=0.134985180404545E+02 gamma(00000274)=0.134985180404545E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 274 z1= 1 -.880262715664414E-06 0.000000000000000E+00 z1= 2 0.892739654720614E-06 0.000000000000000E+00 z1= 3 0.170461107319943E-03 0.000000000000000E+00 alpha(00000274)=0.000000000000000E+00 beta (00000275)=0.128622180561738E+02 gamma(00000275)=0.128622180561738E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 275 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000275)=0.000000000000000E+00 beta (00000276)=0.137440373074687E+02 gamma(00000276)=0.137440373074687E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 276 z1= 1 0.873160536215536E-06 0.000000000000000E+00 z1= 2 -.823044611975845E-06 0.000000000000000E+00 z1= 3 -.142874387783048E-03 0.000000000000000E+00 alpha(00000276)=0.000000000000000E+00 beta (00000277)=0.127464619913646E+02 gamma(00000277)=0.127464619913646E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 277 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000277)=0.000000000000000E+00 beta (00000278)=0.131863522853378E+02 gamma(00000278)=0.131863522853378E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 278 z1= 1 -.901672133882172E-06 0.000000000000000E+00 z1= 2 0.771039879108909E-06 0.000000000000000E+00 z1= 3 0.109693624388935E-03 0.000000000000000E+00 alpha(00000278)=0.000000000000000E+00 beta (00000279)=0.125348482581493E+02 gamma(00000279)=0.125348482581493E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 279 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000279)=0.000000000000000E+00 beta (00000280)=0.133613074100773E+02 gamma(00000280)=0.133613074100773E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 280 z1= 1 0.896016078226003E-06 0.000000000000000E+00 z1= 2 -.703776936694244E-06 0.000000000000000E+00 z1= 3 -.761180235772669E-04 0.000000000000000E+00 alpha(00000280)=0.000000000000000E+00 beta (00000281)=0.128734583968289E+02 gamma(00000281)=0.128734583968289E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 281 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000281)=0.000000000000000E+00 beta (00000282)=0.132961392437314E+02 gamma(00000282)=0.132961392437314E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 282 z1= 1 -.912535820926739E-06 0.000000000000000E+00 z1= 2 0.647095085784782E-06 0.000000000000000E+00 z1= 3 0.277690949047182E-04 0.000000000000000E+00 alpha(00000282)=0.000000000000000E+00 beta (00000283)=0.125942948075747E+02 gamma(00000283)=0.125942948075747E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 283 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000283)=0.000000000000000E+00 beta (00000284)=0.132143367708970E+02 gamma(00000284)=0.132143367708970E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 284 z1= 1 0.909746900843041E-06 0.000000000000000E+00 z1= 2 -.573979622587228E-06 0.000000000000000E+00 z1= 3 0.582131013957144E-04 0.000000000000000E+00 alpha(00000284)=0.000000000000000E+00 beta (00000285)=0.126628114296173E+02 gamma(00000285)=0.126628114296173E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 285 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000285)=0.000000000000000E+00 beta (00000286)=0.134122097358556E+02 gamma(00000286)=0.134122097358556E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 286 z1= 1 -.905927851428874E-06 0.000000000000000E+00 z1= 2 0.504138144356544E-06 0.000000000000000E+00 z1= 3 -.190832693180655E-03 0.000000000000000E+00 alpha(00000286)=0.000000000000000E+00 beta (00000287)=0.126240012323494E+02 gamma(00000287)=0.126240012323494E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 287 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000287)=0.000000000000000E+00 beta (00000288)=0.130876656465496E+02 gamma(00000288)=0.130876656465496E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 288 z1= 1 0.920525971781548E-06 0.000000000000000E+00 z1= 2 -.414213907049368E-06 0.000000000000000E+00 z1= 3 0.349602154668134E-03 0.000000000000000E+00 alpha(00000288)=0.000000000000000E+00 beta (00000289)=0.127646911930806E+02 gamma(00000289)=0.127646911930806E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 289 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000289)=0.000000000000000E+00 beta (00000290)=0.134266767108745E+02 gamma(00000290)=0.134266767108745E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 290 z1= 1 -.927088723384718E-06 0.000000000000000E+00 z1= 2 0.344783483439634E-06 0.000000000000000E+00 z1= 3 -.501146048350665E-03 0.000000000000000E+00 alpha(00000290)=0.000000000000000E+00 beta (00000291)=0.127607112298001E+02 gamma(00000291)=0.127607112298001E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 291 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000291)=0.000000000000000E+00 beta (00000292)=0.131977198915219E+02 gamma(00000292)=0.131977198915219E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 292 z1= 1 0.944096389550540E-06 0.000000000000000E+00 z1= 2 -.251664361859358E-06 0.000000000000000E+00 z1= 3 0.625281949561881E-03 0.000000000000000E+00 alpha(00000292)=0.000000000000000E+00 beta (00000293)=0.126412176915661E+02 gamma(00000293)=0.126412176915661E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 293 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000293)=0.000000000000000E+00 beta (00000294)=0.135269362636948E+02 gamma(00000294)=0.135269362636948E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 294 z1= 1 -.913285294410772E-06 0.000000000000000E+00 z1= 2 0.198728392220915E-06 0.000000000000000E+00 z1= 3 -.725818894986055E-03 0.000000000000000E+00 alpha(00000294)=0.000000000000000E+00 beta (00000295)=0.129785103637072E+02 gamma(00000295)=0.129785103637072E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 295 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000295)=0.000000000000000E+00 beta (00000296)=0.135622799739159E+02 gamma(00000296)=0.135622799739159E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 296 z1= 1 0.904610691123515E-06 0.000000000000000E+00 z1= 2 -.129533907027691E-06 0.000000000000000E+00 z1= 3 0.768601384177944E-03 0.000000000000000E+00 alpha(00000296)=0.000000000000000E+00 beta (00000297)=0.127907385325438E+02 gamma(00000297)=0.127907385325438E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 297 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000297)=0.000000000000000E+00 beta (00000298)=0.133436961898626E+02 gamma(00000298)=0.133436961898626E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 298 z1= 1 -.902351524952158E-06 0.000000000000000E+00 z1= 2 0.910101934221253E-07 0.000000000000000E+00 z1= 3 -.707462199360926E-03 0.000000000000000E+00 alpha(00000298)=0.000000000000000E+00 beta (00000299)=0.130107129245938E+02 gamma(00000299)=0.130107129245938E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 299 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000299)=0.000000000000000E+00 beta (00000300)=0.136889177698054E+02 gamma(00000300)=0.136889177698054E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 300 z1= 1 0.890870992606950E-06 0.000000000000000E+00 z1= 2 -.324937566420034E-07 0.000000000000000E+00 z1= 3 0.684585814798610E-03 0.000000000000000E+00 alpha(00000300)=0.000000000000000E+00 beta (00000301)=0.127325779102483E+02 gamma(00000301)=0.127325779102483E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 301 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000301)=0.000000000000000E+00 beta (00000302)=0.132014512645709E+02 gamma(00000302)=0.132014512645709E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 302 z1= 1 -.907215534756245E-06 0.000000000000000E+00 z1= 2 0.749085360391257E-08 0.000000000000000E+00 z1= 3 -.647234596798748E-03 0.000000000000000E+00 alpha(00000302)=0.000000000000000E+00 beta (00000303)=0.127870291940223E+02 gamma(00000303)=0.127870291940223E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 303 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000303)=0.000000000000000E+00 beta (00000304)=0.135647528982383E+02 gamma(00000304)=0.135647528982383E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 304 z1= 1 0.898162290781878E-06 0.000000000000000E+00 z1= 2 0.177070342863121E-07 0.000000000000000E+00 z1= 3 0.551157711890096E-03 0.000000000000000E+00 alpha(00000304)=0.000000000000000E+00 beta (00000305)=0.128308746770530E+02 gamma(00000305)=0.128308746770530E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 305 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000305)=0.000000000000000E+00 beta (00000306)=0.134495333915455E+02 gamma(00000306)=0.134495333915455E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 306 z1= 1 -.898325725562127E-06 0.000000000000000E+00 z1= 2 -.394639419778976E-07 0.000000000000000E+00 z1= 3 -.426466961671488E-03 0.000000000000000E+00 alpha(00000306)=0.000000000000000E+00 beta (00000307)=0.127987548196408E+02 gamma(00000307)=0.127987548196408E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 307 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000307)=0.000000000000000E+00 beta (00000308)=0.135696286728768E+02 gamma(00000308)=0.135696286728768E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 308 z1= 1 0.883900267442434E-06 0.000000000000000E+00 z1= 2 0.676048127881473E-07 0.000000000000000E+00 z1= 3 0.239683958884571E-03 0.000000000000000E+00 alpha(00000308)=0.000000000000000E+00 beta (00000309)=0.127885424282874E+02 gamma(00000309)=0.127885424282874E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 309 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000309)=0.000000000000000E+00 beta (00000310)=0.133077706194535E+02 gamma(00000310)=0.133077706194535E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 310 z1= 1 -.877730504446889E-06 0.000000000000000E+00 z1= 2 -.111977246935947E-06 0.000000000000000E+00 z1= 3 -.705534329373504E-04 0.000000000000000E+00 alpha(00000310)=0.000000000000000E+00 beta (00000311)=0.127286652128317E+02 gamma(00000311)=0.127286652128317E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 311 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000311)=0.000000000000000E+00 beta (00000312)=0.134430723654603E+02 gamma(00000312)=0.134430723654603E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 312 z1= 1 0.863238084699953E-06 0.000000000000000E+00 z1= 2 0.136260184745466E-06 0.000000000000000E+00 z1= 3 -.739101787417412E-04 0.000000000000000E+00 alpha(00000312)=0.000000000000000E+00 beta (00000313)=0.128578417714761E+02 gamma(00000313)=0.128578417714761E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 313 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000313)=0.000000000000000E+00 beta (00000314)=0.132261668904193E+02 gamma(00000314)=0.132261668904193E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 314 z1= 1 -.880491916493032E-06 0.000000000000000E+00 z1= 2 -.152204755812357E-06 0.000000000000000E+00 z1= 3 0.259051417070941E-03 0.000000000000000E+00 alpha(00000314)=0.000000000000000E+00 beta (00000315)=0.124474653558697E+02 gamma(00000315)=0.124474653558697E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 315 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000315)=0.000000000000000E+00 beta (00000316)=0.134572295461685E+02 gamma(00000316)=0.134572295461685E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 316 z1= 1 0.855648727509880E-06 0.000000000000000E+00 z1= 2 0.114089638967967E-06 0.000000000000000E+00 z1= 3 -.403939736499230E-03 0.000000000000000E+00 alpha(00000316)=0.000000000000000E+00 beta (00000317)=0.125627955037059E+02 gamma(00000317)=0.125627955037059E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 317 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000317)=0.000000000000000E+00 beta (00000318)=0.134454928742506E+02 gamma(00000318)=0.134454928742506E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 318 z1= 1 -.844807595412373E-06 0.000000000000000E+00 z1= 2 -.121145142256023E-06 0.000000000000000E+00 z1= 3 0.507365695535941E-03 0.000000000000000E+00 alpha(00000318)=0.000000000000000E+00 beta (00000319)=0.125691302141704E+02 gamma(00000319)=0.125691302141704E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 319 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000319)=0.000000000000000E+00 beta (00000320)=0.132683663925298E+02 gamma(00000320)=0.132683663925298E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 320 z1= 1 0.850280824967115E-06 0.000000000000000E+00 z1= 2 0.824821224012368E-07 0.000000000000000E+00 z1= 3 -.613601695922263E-03 0.000000000000000E+00 alpha(00000320)=0.000000000000000E+00 beta (00000321)=0.128768110279527E+02 gamma(00000321)=0.128768110279527E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 321 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000321)=0.000000000000000E+00 beta (00000322)=0.135396497745297E+02 gamma(00000322)=0.135396497745297E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 322 z1= 1 -.859388994718354E-06 0.000000000000000E+00 z1= 2 -.682788659457298E-07 0.000000000000000E+00 z1= 3 0.611415171835786E-03 0.000000000000000E+00 alpha(00000322)=0.000000000000000E+00 beta (00000323)=0.127480230295985E+02 gamma(00000323)=0.127480230295985E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 323 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000323)=0.000000000000000E+00 beta (00000324)=0.132686535438582E+02 gamma(00000324)=0.132686535438582E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 324 z1= 1 0.867822754048854E-06 0.000000000000000E+00 z1= 2 0.230282640349211E-07 0.000000000000000E+00 z1= 3 -.593169576848551E-03 0.000000000000000E+00 alpha(00000324)=0.000000000000000E+00 beta (00000325)=0.127942782488542E+02 gamma(00000325)=0.127942782488542E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 325 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000325)=0.000000000000000E+00 beta (00000326)=0.137026903697314E+02 gamma(00000326)=0.137026903697314E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 326 z1= 1 -.846318298243758E-06 0.000000000000000E+00 z1= 2 -.422199867368997E-07 0.000000000000000E+00 z1= 3 0.515054913427835E-03 0.000000000000000E+00 alpha(00000326)=0.000000000000000E+00 beta (00000327)=0.126562903837119E+02 gamma(00000327)=0.126562903837119E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 327 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000327)=0.000000000000000E+00 beta (00000328)=0.132710876207405E+02 gamma(00000328)=0.132710876207405E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 328 z1= 1 0.850153775519222E-06 0.000000000000000E+00 z1= 2 0.840304238409854E-09 0.000000000000000E+00 z1= 3 -.372100983301336E-03 0.000000000000000E+00 alpha(00000328)=0.000000000000000E+00 beta (00000329)=0.128093879753903E+02 gamma(00000329)=0.128093879753903E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 329 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000329)=0.000000000000000E+00 beta (00000330)=0.136222136818207E+02 gamma(00000330)=0.136222136818207E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 330 z1= 1 -.844103226407789E-06 0.000000000000000E+00 z1= 2 -.621522715932299E-08 0.000000000000000E+00 z1= 3 0.204082680014494E-03 0.000000000000000E+00 alpha(00000330)=0.000000000000000E+00 beta (00000331)=0.126670155461000E+02 gamma(00000331)=0.126670155461000E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 331 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000331)=0.000000000000000E+00 beta (00000332)=0.133665195552515E+02 gamma(00000332)=0.133665195552515E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 332 z1= 1 0.845856735538710E-06 0.000000000000000E+00 z1= 2 -.369065611687967E-07 0.000000000000000E+00 z1= 3 0.539121473667678E-05 0.000000000000000E+00 alpha(00000332)=0.000000000000000E+00 beta (00000333)=0.128362148765585E+02 gamma(00000333)=0.128362148765585E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 333 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000333)=0.000000000000000E+00 beta (00000334)=0.134610356272610E+02 gamma(00000334)=0.134610356272610E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 334 z1= 1 -.858421598338229E-06 0.000000000000000E+00 z1= 2 0.389724881014560E-07 0.000000000000000E+00 z1= 3 -.149842481847965E-03 0.000000000000000E+00 alpha(00000334)=0.000000000000000E+00 beta (00000335)=0.124678085059625E+02 gamma(00000335)=0.124678085059625E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 335 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000335)=0.000000000000000E+00 beta (00000336)=0.130935794311875E+02 gamma(00000336)=0.130935794311875E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 336 z1= 1 0.877570924426806E-06 0.000000000000000E+00 z1= 2 -.107652106678176E-06 0.000000000000000E+00 z1= 3 0.268413491873591E-03 0.000000000000000E+00 alpha(00000336)=0.000000000000000E+00 beta (00000337)=0.129076557638503E+02 gamma(00000337)=0.129076557638503E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 337 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000337)=0.000000000000000E+00 beta (00000338)=0.135012750844191E+02 gamma(00000338)=0.135012750844191E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 338 z1= 1 -.895659383552097E-06 0.000000000000000E+00 z1= 2 0.125122275080865E-06 0.000000000000000E+00 z1= 3 -.430408545219299E-03 0.000000000000000E+00 alpha(00000338)=0.000000000000000E+00 beta (00000339)=0.126384417861600E+02 gamma(00000339)=0.126384417861600E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 339 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000339)=0.000000000000000E+00 beta (00000340)=0.132421932688249E+02 gamma(00000340)=0.132421932688249E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 340 z1= 1 0.918066488875312E-06 0.000000000000000E+00 z1= 2 -.184947598884583E-06 0.000000000000000E+00 z1= 3 0.595932060826173E-03 0.000000000000000E+00 alpha(00000340)=0.000000000000000E+00 beta (00000341)=0.126706887890930E+02 gamma(00000341)=0.126706887890930E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 341 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000341)=0.000000000000000E+00 beta (00000342)=0.136753373053318E+02 gamma(00000342)=0.136753373053318E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 342 z1= 1 -.913329590250772E-06 0.000000000000000E+00 z1= 2 0.178172007115241E-06 0.000000000000000E+00 z1= 3 -.712408318393627E-03 0.000000000000000E+00 alpha(00000342)=0.000000000000000E+00 beta (00000343)=0.127943450206585E+02 gamma(00000343)=0.127943450206585E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 343 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000343)=0.000000000000000E+00 beta (00000344)=0.135431202081270E+02 gamma(00000344)=0.135431202081270E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 344 z1= 1 0.934064281816918E-06 0.000000000000000E+00 z1= 2 -.216101643131235E-06 0.000000000000000E+00 z1= 3 0.858067265076525E-03 0.000000000000000E+00 alpha(00000344)=0.000000000000000E+00 beta (00000345)=0.129528039587151E+02 gamma(00000345)=0.129528039587151E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 345 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000345)=0.000000000000000E+00 beta (00000346)=0.134551379514854E+02 gamma(00000346)=0.134551379514854E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 346 z1= 1 -.961737927528903E-06 0.000000000000000E+00 z1= 2 0.223189404202867E-06 0.000000000000000E+00 z1= 3 -.104525541344297E-02 0.000000000000000E+00 alpha(00000346)=0.000000000000000E+00 beta (00000347)=0.125652063363612E+02 gamma(00000347)=0.125652063363612E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 347 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000347)=0.000000000000000E+00 beta (00000348)=0.134783936134887E+02 gamma(00000348)=0.134783936134887E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 348 z1= 1 0.964491614513529E-06 0.000000000000000E+00 z1= 2 -.258539222059307E-06 0.000000000000000E+00 z1= 3 0.116958099299417E-02 0.000000000000000E+00 alpha(00000348)=0.000000000000000E+00 beta (00000349)=0.129740072766135E+02 gamma(00000349)=0.129740072766135E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 349 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000349)=0.000000000000000E+00 beta (00000350)=0.134297951183631E+02 gamma(00000350)=0.134297951183631E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 350 z1= 1 -.993142600357543E-06 0.000000000000000E+00 z1= 2 0.256627711565580E-06 0.000000000000000E+00 z1= 3 -.135361945559912E-02 0.000000000000000E+00 alpha(00000350)=0.000000000000000E+00 beta (00000351)=0.125508481507069E+02 gamma(00000351)=0.125508481507069E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 351 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000351)=0.000000000000000E+00 beta (00000352)=0.134338592024886E+02 gamma(00000352)=0.134338592024886E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 352 z1= 1 0.100484423383503E-05 0.000000000000000E+00 z1= 2 -.266206141483942E-06 0.000000000000000E+00 z1= 3 0.143566911387661E-02 0.000000000000000E+00 alpha(00000352)=0.000000000000000E+00 beta (00000353)=0.129531025588947E+02 gamma(00000353)=0.129531025588947E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 353 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000353)=0.000000000000000E+00 beta (00000354)=0.132873851586602E+02 gamma(00000354)=0.132873851586602E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 354 z1= 1 -.105127080067256E-05 0.000000000000000E+00 z1= 2 0.265805606574775E-06 0.000000000000000E+00 z1= 3 -.157576645599267E-02 0.000000000000000E+00 alpha(00000354)=0.000000000000000E+00 beta (00000355)=0.124749211916428E+02 gamma(00000355)=0.124749211916428E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 355 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000355)=0.000000000000000E+00 beta (00000356)=0.136130035589521E+02 gamma(00000356)=0.136130035589521E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 356 z1= 1 0.102588664688548E-05 0.000000000000000E+00 z1= 2 -.263165290542776E-06 0.000000000000000E+00 z1= 3 0.166805291112152E-02 0.000000000000000E+00 alpha(00000356)=0.000000000000000E+00 beta (00000357)=0.128740605637155E+02 gamma(00000357)=0.128740605637155E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 357 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000357)=0.000000000000000E+00 beta (00000358)=0.136854335673632E+02 gamma(00000358)=0.136854335673632E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 358 z1= 1 -.104557596819016E-05 0.000000000000000E+00 z1= 2 0.261827523835036E-06 0.000000000000000E+00 z1= 3 -.178727968344997E-02 0.000000000000000E+00 alpha(00000358)=0.000000000000000E+00 beta (00000359)=0.126594349078977E+02 gamma(00000359)=0.126594349078977E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 359 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000359)=0.000000000000000E+00 beta (00000360)=0.138515883939966E+02 gamma(00000360)=0.138515883939966E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 360 z1= 1 0.103529983025205E-05 0.000000000000000E+00 z1= 2 -.247960698768679E-06 0.000000000000000E+00 z1= 3 0.183613660513110E-02 0.000000000000000E+00 alpha(00000360)=0.000000000000000E+00 beta (00000361)=0.124128328994191E+02 gamma(00000361)=0.124128328994191E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 361 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000361)=0.000000000000000E+00 beta (00000362)=0.134328014588892E+02 gamma(00000362)=0.134328014588892E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 362 z1= 1 -.104550119655683E-05 0.000000000000000E+00 z1= 2 0.262189967194812E-06 0.000000000000000E+00 z1= 3 -.191589725695719E-02 0.000000000000000E+00 alpha(00000362)=0.000000000000000E+00 beta (00000363)=0.128797663491533E+02 gamma(00000363)=0.128797663491533E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 363 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000363)=0.000000000000000E+00 beta (00000364)=0.135103355849907E+02 gamma(00000364)=0.135103355849907E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 364 z1= 1 0.108766126385727E-05 0.000000000000000E+00 z1= 2 -.247017739963564E-06 0.000000000000000E+00 z1= 3 0.201948524572165E-02 0.000000000000000E+00 alpha(00000364)=0.000000000000000E+00 beta (00000365)=0.122994594563962E+02 gamma(00000365)=0.122994594563962E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 365 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000365)=0.000000000000000E+00 beta (00000366)=0.129062777509899E+02 gamma(00000366)=0.129062777509899E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 366 z1= 1 -.114131212271879E-05 0.000000000000000E+00 z1= 2 0.272727355148388E-06 0.000000000000000E+00 z1= 3 -.211655244489869E-02 0.000000000000000E+00 alpha(00000366)=0.000000000000000E+00 beta (00000367)=0.127034506719825E+02 gamma(00000367)=0.127034506719825E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 367 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000367)=0.000000000000000E+00 beta (00000368)=0.134766948016701E+02 gamma(00000368)=0.134766948016701E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 368 z1= 1 0.117145710117208E-05 0.000000000000000E+00 z1= 2 -.231418201918142E-06 0.000000000000000E+00 z1= 3 0.215020004751112E-02 0.000000000000000E+00 alpha(00000368)=0.000000000000000E+00 beta (00000369)=0.125626419984281E+02 gamma(00000369)=0.125626419984281E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 369 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000369)=0.000000000000000E+00 beta (00000370)=0.133692492072694E+02 gamma(00000370)=0.133692492072694E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 370 z1= 1 -.121027425345908E-05 0.000000000000000E+00 z1= 2 0.249701066810091E-06 0.000000000000000E+00 z1= 3 -.212543001670369E-02 0.000000000000000E+00 alpha(00000370)=0.000000000000000E+00 beta (00000371)=0.128826973691614E+02 gamma(00000371)=0.128826973691614E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 371 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000371)=0.000000000000000E+00 beta (00000372)=0.133106398040417E+02 gamma(00000372)=0.133106398040417E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 372 z1= 1 0.127230000902942E-05 0.000000000000000E+00 z1= 2 -.187918472759237E-06 0.000000000000000E+00 z1= 3 0.214724156124336E-02 0.000000000000000E+00 alpha(00000372)=0.000000000000000E+00 beta (00000373)=0.128998889817155E+02 gamma(00000373)=0.128998889817155E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 373 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000373)=0.000000000000000E+00 beta (00000374)=0.136448356973695E+02 gamma(00000374)=0.136448356973695E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 374 z1= 1 -.130818793281590E-05 0.000000000000000E+00 z1= 2 0.217900948492732E-06 0.000000000000000E+00 z1= 3 -.207157295029114E-02 0.000000000000000E+00 alpha(00000374)=0.000000000000000E+00 beta (00000375)=0.128456387119421E+02 gamma(00000375)=0.128456387119421E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 375 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000375)=0.000000000000000E+00 beta (00000376)=0.131827122335220E+02 gamma(00000376)=0.131827122335220E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 376 z1= 1 0.137681166167560E-05 0.000000000000000E+00 z1= 2 -.143846616661517E-06 0.000000000000000E+00 z1= 3 0.196861542758153E-02 0.000000000000000E+00 alpha(00000376)=0.000000000000000E+00 beta (00000377)=0.130315133237395E+02 gamma(00000377)=0.130315133237395E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 377 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000377)=0.000000000000000E+00 beta (00000378)=0.135748828858725E+02 gamma(00000378)=0.135748828858725E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 378 z1= 1 -.143853514602966E-05 0.000000000000000E+00 z1= 2 0.184505637759605E-06 0.000000000000000E+00 z1= 3 -.176134882907832E-02 0.000000000000000E+00 alpha(00000378)=0.000000000000000E+00 beta (00000379)=0.125824292375232E+02 gamma(00000379)=0.125824292375232E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 379 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000379)=0.000000000000000E+00 beta (00000380)=0.133817811372825E+02 gamma(00000380)=0.133817811372825E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 380 z1= 1 0.146332171315804E-05 0.000000000000000E+00 z1= 2 -.101714448351789E-06 0.000000000000000E+00 z1= 3 0.147093627043692E-02 0.000000000000000E+00 alpha(00000380)=0.000000000000000E+00 beta (00000381)=0.131035197958078E+02 gamma(00000381)=0.131035197958078E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 381 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000381)=0.000000000000000E+00 beta (00000382)=0.134408646313890E+02 gamma(00000382)=0.134408646313890E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 382 z1= 1 -.153024463397396E-05 0.000000000000000E+00 z1= 2 0.112534338627844E-06 0.000000000000000E+00 z1= 3 -.127878084786829E-02 0.000000000000000E+00 alpha(00000382)=0.000000000000000E+00 beta (00000383)=0.129349967806138E+02 gamma(00000383)=0.129349967806138E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 383 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000383)=0.000000000000000E+00 beta (00000384)=0.134944096150774E+02 gamma(00000384)=0.134944096150774E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 384 z1= 1 0.155375714784442E-05 0.000000000000000E+00 z1= 2 -.229042659838363E-07 0.000000000000000E+00 z1= 3 0.111247077829812E-02 0.000000000000000E+00 alpha(00000384)=0.000000000000000E+00 beta (00000385)=0.126533462667551E+02 gamma(00000385)=0.126533462667551E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 385 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000385)=0.000000000000000E+00 beta (00000386)=0.130169273392612E+02 gamma(00000386)=0.130169273392612E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 386 z1= 1 -.160214891425394E-05 0.000000000000000E+00 z1= 2 -.295432998399271E-08 0.000000000000000E+00 z1= 3 -.969001939364590E-03 0.000000000000000E+00 alpha(00000386)=0.000000000000000E+00 beta (00000387)=0.129062920159321E+02 gamma(00000387)=0.129062920159321E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 387 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000387)=0.000000000000000E+00 beta (00000388)=0.133571880844773E+02 gamma(00000388)=0.133571880844773E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 388 z1= 1 0.162752450160705E-05 0.000000000000000E+00 z1= 2 0.106546567620091E-06 0.000000000000000E+00 z1= 3 0.840174353654485E-03 0.000000000000000E+00 alpha(00000388)=0.000000000000000E+00 beta (00000389)=0.125858504389911E+02 gamma(00000389)=0.125858504389911E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 389 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000389)=0.000000000000000E+00 beta (00000390)=0.134760626930831E+02 gamma(00000390)=0.134760626930831E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 390 z1= 1 -.158866200541786E-05 0.000000000000000E+00 z1= 2 -.172679434100450E-06 0.000000000000000E+00 z1= 3 -.731679091260820E-03 0.000000000000000E+00 alpha(00000390)=0.000000000000000E+00 beta (00000391)=0.129061939159410E+02 gamma(00000391)=0.129061939159410E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 391 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000391)=0.000000000000000E+00 beta (00000392)=0.131950787381988E+02 gamma(00000392)=0.131950787381988E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 392 z1= 1 0.161866909418006E-05 0.000000000000000E+00 z1= 2 0.273481709362139E-06 0.000000000000000E+00 z1= 3 0.745916347394434E-03 0.000000000000000E+00 alpha(00000392)=0.000000000000000E+00 beta (00000393)=0.126542969630551E+02 gamma(00000393)=0.126542969630551E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 393 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000393)=0.000000000000000E+00 beta (00000394)=0.133841612018826E+02 gamma(00000394)=0.133841612018826E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 394 z1= 1 -.158809474912972E-05 0.000000000000000E+00 z1= 2 -.339923594764929E-06 0.000000000000000E+00 z1= 3 -.722972182756612E-03 0.000000000000000E+00 alpha(00000394)=0.000000000000000E+00 beta (00000395)=0.126876807496503E+02 gamma(00000395)=0.126876807496503E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 395 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000395)=0.000000000000000E+00 beta (00000396)=0.132038159500247E+02 gamma(00000396)=0.132038159500247E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 396 z1= 1 0.158568431852732E-05 0.000000000000000E+00 z1= 2 0.417288723686404E-06 0.000000000000000E+00 z1= 3 0.634900169733527E-03 0.000000000000000E+00 alpha(00000396)=0.000000000000000E+00 beta (00000397)=0.127102686656377E+02 gamma(00000397)=0.127102686656377E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 397 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000397)=0.000000000000000E+00 beta (00000398)=0.131579794101095E+02 gamma(00000398)=0.131579794101095E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 398 z1= 1 -.159067119077743E-05 0.000000000000000E+00 z1= 2 -.502314794576571E-06 0.000000000000000E+00 z1= 3 -.431060924727038E-03 0.000000000000000E+00 alpha(00000398)=0.000000000000000E+00 beta (00000399)=0.126877647007954E+02 gamma(00000399)=0.126877647007954E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 399 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000399)=0.000000000000000E+00 beta (00000400)=0.136083901818274E+02 gamma(00000400)=0.136083901818274E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 400 z1= 1 0.154612990634607E-05 0.000000000000000E+00 z1= 2 0.526454854262478E-06 0.000000000000000E+00 z1= 3 0.189934818955049E-03 0.000000000000000E+00 alpha(00000400)=0.000000000000000E+00 beta (00000401)=0.128719400965169E+02 gamma(00000401)=0.128719400965169E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 401 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000401)=0.000000000000000E+00 beta (00000402)=0.132282567864358E+02 gamma(00000402)=0.132282567864358E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 402 z1= 1 -.156014468677084E-05 0.000000000000000E+00 z1= 2 -.612063286274591E-06 0.000000000000000E+00 z1= 3 0.835909071935613E-04 0.000000000000000E+00 alpha(00000402)=0.000000000000000E+00 beta (00000403)=0.129674337641810E+02 gamma(00000403)=0.129674337641810E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 403 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000403)=0.000000000000000E+00 beta (00000404)=0.133464177619936E+02 gamma(00000404)=0.133464177619936E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 404 z1= 1 0.156719735088212E-05 0.000000000000000E+00 z1= 2 0.651033001011203E-06 0.000000000000000E+00 z1= 3 -.280802070311784E-03 0.000000000000000E+00 alpha(00000404)=0.000000000000000E+00 beta (00000405)=0.126603030847278E+02 gamma(00000405)=0.126603030847278E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 405 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000405)=0.000000000000000E+00 beta (00000406)=0.135477418865919E+02 gamma(00000406)=0.135477418865919E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 406 z1= 1 -.151492951209697E-05 0.000000000000000E+00 z1= 2 -.679922599172256E-06 0.000000000000000E+00 z1= 3 0.445979697657934E-03 0.000000000000000E+00 alpha(00000406)=0.000000000000000E+00 beta (00000407)=0.127114632111100E+02 gamma(00000407)=0.127114632111100E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 407 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000407)=0.000000000000000E+00 beta (00000408)=0.130764906374438E+02 gamma(00000408)=0.130764906374438E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 408 z1= 1 0.153820581013915E-05 0.000000000000000E+00 z1= 2 0.679293838960391E-06 0.000000000000000E+00 z1= 3 -.686985345386890E-03 0.000000000000000E+00 alpha(00000408)=0.000000000000000E+00 beta (00000409)=0.129445344361590E+02 gamma(00000409)=0.129445344361590E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 409 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000409)=0.000000000000000E+00 beta (00000410)=0.133572084191845E+02 gamma(00000410)=0.133572084191845E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 410 z1= 1 -.154846834304727E-05 0.000000000000000E+00 z1= 2 -.731872611127470E-06 0.000000000000000E+00 z1= 3 0.927556207086427E-03 0.000000000000000E+00 alpha(00000410)=0.000000000000000E+00 beta (00000411)=0.128095543370521E+02 gamma(00000411)=0.128095543370521E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 411 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000411)=0.000000000000000E+00 beta (00000412)=0.138140877714809E+02 gamma(00000412)=0.138140877714809E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 412 z1= 1 0.150531457786572E-05 0.000000000000000E+00 z1= 2 0.697426756417121E-06 0.000000000000000E+00 z1= 3 -.106207165302378E-02 0.000000000000000E+00 alpha(00000412)=0.000000000000000E+00 beta (00000413)=0.124499041269609E+02 gamma(00000413)=0.124499041269609E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 413 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000413)=0.000000000000000E+00 beta (00000414)=0.133787623580096E+02 gamma(00000414)=0.133787623580096E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 414 z1= 1 -.146616124358483E-05 0.000000000000000E+00 z1= 2 -.729310780607940E-06 0.000000000000000E+00 z1= 3 0.111328319800315E-02 0.000000000000000E+00 alpha(00000414)=0.000000000000000E+00 beta (00000415)=0.130605798032988E+02 gamma(00000415)=0.130605798032988E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 415 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000415)=0.000000000000000E+00 beta (00000416)=0.135228159456446E+02 gamma(00000416)=0.135228159456446E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 416 z1= 1 0.148758999376206E-05 0.000000000000000E+00 z1= 2 0.706530505301855E-06 0.000000000000000E+00 z1= 3 -.106537402068291E-02 0.000000000000000E+00 alpha(00000416)=0.000000000000000E+00 beta (00000417)=0.126275316721428E+02 gamma(00000417)=0.126275316721428E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 417 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000417)=0.000000000000000E+00 beta (00000418)=0.138147940586449E+02 gamma(00000418)=0.138147940586449E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 418 z1= 1 -.142187706116061E-05 0.000000000000000E+00 z1= 2 -.721984122864982E-06 0.000000000000000E+00 z1= 3 0.855613633287573E-03 0.000000000000000E+00 alpha(00000418)=0.000000000000000E+00 beta (00000419)=0.126621266527208E+02 gamma(00000419)=0.126621266527208E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 419 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000419)=0.000000000000000E+00 beta (00000420)=0.135334961801957E+02 gamma(00000420)=0.135334961801957E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 420 z1= 1 0.140528551216849E-05 0.000000000000000E+00 z1= 2 0.663971992409659E-06 0.000000000000000E+00 z1= 3 -.679847993761140E-03 0.000000000000000E+00 alpha(00000420)=0.000000000000000E+00 beta (00000421)=0.128427800532329E+02 gamma(00000421)=0.128427800532329E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 421 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000421)=0.000000000000000E+00 beta (00000422)=0.130972381782816E+02 gamma(00000422)=0.130972381782816E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 422 z1= 1 -.145381828561841E-05 0.000000000000000E+00 z1= 2 -.695378871064505E-06 0.000000000000000E+00 z1= 3 0.621482268328595E-03 0.000000000000000E+00 alpha(00000422)=0.000000000000000E+00 beta (00000423)=0.127561520897601E+02 gamma(00000423)=0.127561520897601E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 423 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000423)=0.000000000000000E+00 beta (00000424)=0.136009993655058E+02 gamma(00000424)=0.136009993655058E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 424 z1= 1 0.143490560604287E-05 0.000000000000000E+00 z1= 2 0.607623718265528E-06 0.000000000000000E+00 z1= 3 -.547571648853100E-03 0.000000000000000E+00 alpha(00000424)=0.000000000000000E+00 beta (00000425)=0.123518205979464E+02 gamma(00000425)=0.123518205979464E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 425 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000425)=0.000000000000000E+00 beta (00000426)=0.137429613049663E+02 gamma(00000426)=0.137429613049663E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 426 z1= 1 -.137279676169582E-05 0.000000000000000E+00 z1= 2 -.577960810490717E-06 0.000000000000000E+00 z1= 3 0.421943919713681E-03 0.000000000000000E+00 alpha(00000426)=0.000000000000000E+00 beta (00000427)=0.127408214535623E+02 gamma(00000427)=0.127408214535623E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 427 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000427)=0.000000000000000E+00 beta (00000428)=0.133044973477618E+02 gamma(00000428)=0.133044973477618E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 428 z1= 1 0.141782046936181E-05 0.000000000000000E+00 z1= 2 0.516868737816269E-06 0.000000000000000E+00 z1= 3 -.212762144393450E-03 0.000000000000000E+00 alpha(00000428)=0.000000000000000E+00 beta (00000429)=0.128353544095956E+02 gamma(00000429)=0.128353544095956E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 429 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000429)=0.000000000000000E+00 beta (00000430)=0.132090497151444E+02 gamma(00000430)=0.132090497151444E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 430 z1= 1 -.145982716117266E-05 0.000000000000000E+00 z1= 2 -.528339139896578E-06 0.000000000000000E+00 z1= 3 -.141288262773532E-03 0.000000000000000E+00 alpha(00000430)=0.000000000000000E+00 beta (00000431)=0.129472435777760E+02 gamma(00000431)=0.129472435777760E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 431 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000431)=0.000000000000000E+00 beta (00000432)=0.135190703013985E+02 gamma(00000432)=0.135190703013985E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 432 z1= 1 0.147052147750522E-05 0.000000000000000E+00 z1= 2 0.457657918679537E-06 0.000000000000000E+00 z1= 3 0.469821592272358E-03 0.000000000000000E+00 alpha(00000432)=0.000000000000000E+00 beta (00000433)=0.125895558447640E+02 gamma(00000433)=0.125895558447640E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 433 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000433)=0.000000000000000E+00 beta (00000434)=0.137837506127573E+02 gamma(00000434)=0.137837506127573E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 434 z1= 1 -.141464906198291E-05 0.000000000000000E+00 z1= 2 -.448470689291586E-06 0.000000000000000E+00 z1= 3 -.699539713353001E-03 0.000000000000000E+00 alpha(00000434)=0.000000000000000E+00 beta (00000435)=0.128837871725798E+02 gamma(00000435)=0.128837871725798E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 435 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000435)=0.000000000000000E+00 beta (00000436)=0.132266147154652E+02 gamma(00000436)=0.132266147154652E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 436 z1= 1 0.147273113910464E-05 0.000000000000000E+00 z1= 2 0.406513846249292E-06 0.000000000000000E+00 z1= 3 0.900608087873407E-03 0.000000000000000E+00 alpha(00000436)=0.000000000000000E+00 beta (00000437)=0.129067997987740E+02 gamma(00000437)=0.129067997987740E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 437 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000437)=0.000000000000000E+00 beta (00000438)=0.128547229416295E+02 gamma(00000438)=0.128547229416295E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 438 z1= 1 -.157848638437079E-05 0.000000000000000E+00 z1= 2 -.416039479493124E-06 0.000000000000000E+00 z1= 3 -.935635257585585E-03 0.000000000000000E+00 alpha(00000438)=0.000000000000000E+00 beta (00000439)=0.127824543107614E+02 gamma(00000439)=0.127824543107614E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 439 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000439)=0.000000000000000E+00 beta (00000440)=0.133184571088201E+02 gamma(00000440)=0.133184571088201E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 440 z1= 1 0.160455407259539E-05 0.000000000000000E+00 z1= 2 0.386224118476333E-06 0.000000000000000E+00 z1= 3 0.810786448013896E-03 0.000000000000000E+00 alpha(00000440)=0.000000000000000E+00 beta (00000441)=0.124654903111043E+02 gamma(00000441)=0.124654903111043E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 441 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000441)=0.000000000000000E+00 beta (00000442)=0.134802894187853E+02 gamma(00000442)=0.134802894187853E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 442 z1= 1 -.157824705911011E-05 0.000000000000000E+00 z1= 2 -.370504769232568E-06 0.000000000000000E+00 z1= 3 -.516723672055309E-03 0.000000000000000E+00 alpha(00000442)=0.000000000000000E+00 beta (00000443)=0.125905872635202E+02 gamma(00000443)=0.125905872635202E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 443 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000443)=0.000000000000000E+00 beta (00000444)=0.133373843698145E+02 gamma(00000444)=0.133373843698145E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 444 z1= 1 0.159140581428553E-05 0.000000000000000E+00 z1= 2 0.358438444400468E-06 0.000000000000000E+00 z1= 3 0.180811874267587E-03 0.000000000000000E+00 alpha(00000444)=0.000000000000000E+00 beta (00000445)=0.132098631454005E+02 gamma(00000445)=0.132098631454005E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 445 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000445)=0.000000000000000E+00 beta (00000446)=0.130285525989132E+02 gamma(00000446)=0.130285525989132E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 446 z1= 1 -.171096945112982E-05 0.000000000000000E+00 z1= 2 -.370815401022607E-06 0.000000000000000E+00 z1= 3 0.129774841020959E-03 0.000000000000000E+00 alpha(00000446)=0.000000000000000E+00 beta (00000447)=0.129522345513029E+02 gamma(00000447)=0.129522345513029E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 447 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000447)=0.000000000000000E+00 beta (00000448)=0.132092077659276E+02 gamma(00000448)=0.132092077659276E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 448 z1= 1 0.176586606393902E-05 0.000000000000000E+00 z1= 2 0.391112146086664E-06 0.000000000000000E+00 z1= 3 -.343660162654778E-03 0.000000000000000E+00 alpha(00000448)=0.000000000000000E+00 beta (00000449)=0.129489694678041E+02 gamma(00000449)=0.129489694678041E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 449 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000449)=0.000000000000000E+00 beta (00000450)=0.136504025432705E+02 gamma(00000450)=0.136504025432705E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 450 z1= 1 -.174801863420267E-05 0.000000000000000E+00 z1= 2 -.377850785974630E-06 0.000000000000000E+00 z1= 3 0.462101670709630E-03 0.000000000000000E+00 alpha(00000450)=0.000000000000000E+00 beta (00000451)=0.124501730117260E+02 gamma(00000451)=0.124501730117260E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 451 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000451)=0.000000000000000E+00 beta (00000452)=0.137434202664513E+02 gamma(00000452)=0.137434202664513E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 452 z1= 1 0.166197233217834E-05 0.000000000000000E+00 z1= 2 0.375300470796406E-06 0.000000000000000E+00 z1= 3 -.621547591021523E-03 0.000000000000000E+00 alpha(00000452)=0.000000000000000E+00 beta (00000453)=0.123492923787822E+02 gamma(00000453)=0.123492923787822E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 453 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000453)=0.000000000000000E+00 beta (00000454)=0.136342946054680E+02 gamma(00000454)=0.136342946054680E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 454 z1= 1 -.159864766387127E-05 0.000000000000000E+00 z1= 2 -.313741836252632E-06 0.000000000000000E+00 z1= 3 0.740762086410401E-03 0.000000000000000E+00 alpha(00000454)=0.000000000000000E+00 beta (00000455)=0.124948952471787E+02 gamma(00000455)=0.124948952471787E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 455 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000455)=0.000000000000000E+00 beta (00000456)=0.136130030454256E+02 gamma(00000456)=0.136130030454256E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 456 z1= 1 0.155587790998547E-05 0.000000000000000E+00 z1= 2 0.305237187649219E-06 0.000000000000000E+00 z1= 3 -.936690019165656E-03 0.000000000000000E+00 alpha(00000456)=0.000000000000000E+00 beta (00000457)=0.127298041810865E+02 gamma(00000457)=0.127298041810865E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 457 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000457)=0.000000000000000E+00 beta (00000458)=0.134663452736753E+02 gamma(00000458)=0.134663452736753E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 458 z1= 1 -.157647312997784E-05 0.000000000000000E+00 z1= 2 -.225506728555565E-06 0.000000000000000E+00 z1= 3 0.110717239958834E-02 0.000000000000000E+00 alpha(00000458)=0.000000000000000E+00 beta (00000459)=0.129360974683917E+02 gamma(00000459)=0.129360974683917E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 459 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000459)=0.000000000000000E+00 beta (00000460)=0.134362650812136E+02 gamma(00000460)=0.134362650812136E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 460 z1= 1 0.160263641219867E-05 0.000000000000000E+00 z1= 2 0.222458834174891E-06 0.000000000000000E+00 z1= 3 -.121671490165785E-02 0.000000000000000E+00 alpha(00000460)=0.000000000000000E+00 beta (00000461)=0.127149981396893E+02 gamma(00000461)=0.127149981396893E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 461 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000461)=0.000000000000000E+00 beta (00000462)=0.133073050017409E+02 gamma(00000462)=0.133073050017409E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 462 z1= 1 -.163684490456153E-05 0.000000000000000E+00 z1= 2 -.116212889931754E-06 0.000000000000000E+00 z1= 3 0.123513012779260E-02 0.000000000000000E+00 alpha(00000462)=0.000000000000000E+00 beta (00000463)=0.130288464339842E+02 gamma(00000463)=0.130288464339842E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 463 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000463)=0.000000000000000E+00 beta (00000464)=0.134211024300303E+02 gamma(00000464)=0.134211024300303E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 464 z1= 1 0.169540029383111E-05 0.000000000000000E+00 z1= 2 0.963341908549417E-07 0.000000000000000E+00 z1= 3 -.114486027074273E-02 0.000000000000000E+00 alpha(00000464)=0.000000000000000E+00 beta (00000465)=0.126554501553061E+02 gamma(00000465)=0.126554501553061E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 465 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000465)=0.000000000000000E+00 beta (00000466)=0.134457786287963E+02 gamma(00000466)=0.134457786287963E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 466 z1= 1 -.170621634420430E-05 0.000000000000000E+00 z1= 2 0.102729812391164E-07 0.000000000000000E+00 z1= 3 0.100054173108437E-02 0.000000000000000E+00 alpha(00000466)=0.000000000000000E+00 beta (00000467)=0.128140988756160E+02 gamma(00000467)=0.128140988756160E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 467 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000467)=0.000000000000000E+00 beta (00000468)=0.136873258289409E+02 gamma(00000468)=0.136873258289409E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 468 z1= 1 0.169618807525545E-05 0.000000000000000E+00 z1= 2 -.431385434405268E-08 0.000000000000000E+00 z1= 3 -.837464911866845E-03 0.000000000000000E+00 alpha(00000468)=0.000000000000000E+00 beta (00000469)=0.126931687259611E+02 gamma(00000469)=0.126931687259611E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 469 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000469)=0.000000000000000E+00 beta (00000470)=0.136810377833230E+02 gamma(00000470)=0.136810377833230E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 470 z1= 1 -.168191801045716E-05 0.000000000000000E+00 z1= 2 0.106841020811738E-06 0.000000000000000E+00 z1= 3 0.602729214429290E-03 0.000000000000000E+00 alpha(00000470)=0.000000000000000E+00 beta (00000471)=0.127563616568712E+02 gamma(00000471)=0.127563616568712E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 471 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000471)=0.000000000000000E+00 beta (00000472)=0.133838613102552E+02 gamma(00000472)=0.133838613102552E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 472 z1= 1 0.170653570927986E-05 0.000000000000000E+00 z1= 2 -.116824585449276E-06 0.000000000000000E+00 z1= 3 -.376437853446920E-03 0.000000000000000E+00 alpha(00000472)=0.000000000000000E+00 beta (00000473)=0.126367610178153E+02 gamma(00000473)=0.126367610178153E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 473 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000473)=0.000000000000000E+00 beta (00000474)=0.134964324776565E+02 gamma(00000474)=0.134964324776565E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 474 z1= 1 -.170035166481119E-05 0.000000000000000E+00 z1= 2 0.192608232536372E-06 0.000000000000000E+00 z1= 3 0.138260351664357E-03 0.000000000000000E+00 alpha(00000474)=0.000000000000000E+00 beta (00000475)=0.127392766365606E+02 gamma(00000475)=0.127392766365606E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 475 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000475)=0.000000000000000E+00 beta (00000476)=0.133043317721145E+02 gamma(00000476)=0.133043317721145E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 476 z1= 1 0.173694136534083E-05 0.000000000000000E+00 z1= 2 -.185314599095675E-06 0.000000000000000E+00 z1= 3 -.337873353447845E-05 0.000000000000000E+00 alpha(00000476)=0.000000000000000E+00 beta (00000477)=0.126415261663525E+02 gamma(00000477)=0.126415261663525E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 477 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000477)=0.000000000000000E+00 beta (00000478)=0.133306251775365E+02 gamma(00000478)=0.133306251775365E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 478 z1= 1 -.176240194921327E-05 0.000000000000000E+00 z1= 2 0.234582904364098E-06 0.000000000000000E+00 z1= 3 -.894890375254557E-04 0.000000000000000E+00 alpha(00000478)=0.000000000000000E+00 beta (00000479)=0.126280449578772E+02 gamma(00000479)=0.126280449578772E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 479 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000479)=0.000000000000000E+00 beta (00000480)=0.133935339587214E+02 gamma(00000480)=0.133935339587214E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 480 z1= 1 0.178966230798654E-05 0.000000000000000E+00 z1= 2 -.259719269926021E-06 0.000000000000000E+00 z1= 3 0.171353638887217E-03 0.000000000000000E+00 alpha(00000480)=0.000000000000000E+00 beta (00000481)=0.126439244074454E+02 gamma(00000481)=0.126439244074454E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 481 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000481)=0.000000000000000E+00 beta (00000482)=0.134762750745675E+02 gamma(00000482)=0.134762750745675E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 482 z1= 1 -.182174448691731E-05 0.000000000000000E+00 z1= 2 0.286513547364739E-06 0.000000000000000E+00 z1= 3 -.275199578778312E-03 0.000000000000000E+00 alpha(00000482)=0.000000000000000E+00 beta (00000483)=0.127040144432327E+02 gamma(00000483)=0.127040144432327E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 483 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000483)=0.000000000000000E+00 beta (00000484)=0.136555001935686E+02 gamma(00000484)=0.136555001935686E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 484 z1= 1 0.182997233333815E-05 0.000000000000000E+00 z1= 2 -.296439878380030E-06 0.000000000000000E+00 z1= 3 0.373812420015648E-03 0.000000000000000E+00 alpha(00000484)=0.000000000000000E+00 beta (00000485)=0.126719432145867E+02 gamma(00000485)=0.126719432145867E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 485 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000485)=0.000000000000000E+00 beta (00000486)=0.132368047448267E+02 gamma(00000486)=0.132368047448267E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 486 z1= 1 -.189899447369243E-05 0.000000000000000E+00 z1= 2 0.325793361430067E-06 0.000000000000000E+00 z1= 3 -.477744480752816E-03 0.000000000000000E+00 alpha(00000486)=0.000000000000000E+00 beta (00000487)=0.124437261861195E+02 gamma(00000487)=0.124437261861195E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 487 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000487)=0.000000000000000E+00 beta (00000488)=0.134512532092274E+02 gamma(00000488)=0.134512532092274E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 488 z1= 1 0.192142727328621E-05 0.000000000000000E+00 z1= 2 -.401840809781363E-06 0.000000000000000E+00 z1= 3 0.507452897499268E-03 0.000000000000000E+00 alpha(00000488)=0.000000000000000E+00 beta (00000489)=0.128384028478170E+02 gamma(00000489)=0.128384028478170E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 489 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000489)=0.000000000000000E+00 beta (00000490)=0.132658282283567E+02 gamma(00000490)=0.132658282283567E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 490 z1= 1 -.202337340542727E-05 0.000000000000000E+00 z1= 2 0.406467269782108E-06 0.000000000000000E+00 z1= 3 -.576794970680383E-03 0.000000000000000E+00 alpha(00000490)=0.000000000000000E+00 beta (00000491)=0.125999547977457E+02 gamma(00000491)=0.125999547977457E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 491 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000491)=0.000000000000000E+00 beta (00000492)=0.134509578383365E+02 gamma(00000492)=0.134509578383365E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 492 z1= 1 0.206698168493723E-05 0.000000000000000E+00 z1= 2 -.469258414710296E-06 0.000000000000000E+00 z1= 3 0.649007795192801E-03 0.000000000000000E+00 alpha(00000492)=0.000000000000000E+00 beta (00000493)=0.127242711727466E+02 gamma(00000493)=0.127242711727466E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 493 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000493)=0.000000000000000E+00 beta (00000494)=0.132863157154913E+02 gamma(00000494)=0.132863157154913E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 494 z1= 1 -.214886609022294E-05 0.000000000000000E+00 z1= 2 0.445621500224454E-06 0.000000000000000E+00 z1= 3 -.798422898724474E-03 0.000000000000000E+00 alpha(00000494)=0.000000000000000E+00 beta (00000495)=0.124537358460341E+02 gamma(00000495)=0.124537358460341E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 495 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000495)=0.000000000000000E+00 beta (00000496)=0.134982169354984E+02 gamma(00000496)=0.134982169354984E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 496 z1= 1 0.216983142513631E-05 0.000000000000000E+00 z1= 2 -.552501027290854E-06 0.000000000000000E+00 z1= 3 0.848444396267198E-03 0.000000000000000E+00 alpha(00000496)=0.000000000000000E+00 beta (00000497)=0.128385346915888E+02 gamma(00000497)=0.128385346915888E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 497 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000497)=0.000000000000000E+00 beta (00000498)=0.133352145988185E+02 gamma(00000498)=0.133352145988185E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 498 z1= 1 -.225933286496682E-05 0.000000000000000E+00 z1= 2 0.500109016789477E-06 0.000000000000000E+00 z1= 3 -.918959575886864E-03 0.000000000000000E+00 alpha(00000498)=0.000000000000000E+00 beta (00000499)=0.126817394774924E+02 gamma(00000499)=0.126817394774924E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 499 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000499)=0.000000000000000E+00 beta (00000500)=0.134573525727283E+02 gamma(00000500)=0.134573525727283E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 500 z1= 1 0.231666516413919E-05 0.000000000000000E+00 z1= 2 -.662624369048015E-06 0.000000000000000E+00 z1= 3 0.105297229333066E-02 0.000000000000000E+00 alpha(00000500)=0.000000000000000E+00 beta (00000501)=0.127046759927261E+02 gamma(00000501)=0.127046759927261E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal End of Lanczos iterations Finished linear response calculation... lr_main : 602.77s CPU 639.02s WALL ( 1 calls) lr_solve_e : 4.66s CPU 4.86s WALL ( 1 calls) one_step : 597.21s CPU 632.88s WALL ( 1500 calls) lr_apply : 584.80s CPU 618.79s WALL ( 3006 calls) lr_apply_int : 447.30s CPU 473.20s WALL ( 1503 calls) lr_apply_no : 137.50s CPU 145.59s WALL ( 1503 calls) lr_apply : 584.80s CPU 618.79s WALL ( 3006 calls) h_psi : 271.17s CPU 286.54s WALL ( 3006 calls) lr_calc_dens : 85.25s CPU 90.11s WALL ( 1503 calls) lr_ortho : 3.25s CPU 3.47s WALL ( 3000 calls) interaction : 75.14s CPU 79.86s WALL ( 1503 calls) lr_dot : 1.94s CPU 2.07s WALL ( 3753 calls) US routines lr_sm1_psi : 0.92s CPU 1.05s WALL ( 3006 calls) General routines calbec : 3.21s CPU 3.37s WALL ( 4605 calls) fft : 106.26s CPU 112.08s WALL ( 3009 calls) fftw : 354.27s CPU 374.79s WALL ( 18214 calls) interpolate : 2.20s CPU 2.28s WALL ( 1503 calls) davcio : 0.00s CPU 0.09s WALL ( 50 calls) Parallel routines fft_scatter : 152.45s CPU 162.01s WALL ( 21223 calls) TDDFPT : 10m 2.79s CPU 10m39.05s WALL This run was terminated on: 13:17:10 12Jan2012 =------------------------------------------------------------------------------= JOB DONE. =------------------------------------------------------------------------------= TDDFPT/Examples/CH4-PR/CH4-PR.tddfpt-ref-s20000644000175000017500000330705012341371500016002 0ustar mbamba Program TDDFPT v.4.99 starts on 13Jan2012 at 14:53:23 This program is part of the open-source Quantum ESPRESSO suite for quantum simulation of materials; please cite "P. Giannozzi et al., J. Phys.:Condens. Matter 21 395502 (2009); URL http://www.quantum-espresso.org", in publications or presentations arising from this work. More details at http://www.quantum-espresso.org/quote.php Parallel version (MPI), running on 4 processors R & G space division: proc/pool = 4 ---------------------------------------- This is TDDFPT (Time Dependent Density Functional Perturbation Theory) Sub Version: 0.9 ---------------------------------------- Ultrasoft (Vanderbilt) Pseudopotentials Prefix of current run is appended by -stage2 Info: using nr1, nr2, nr3 values from input Info: using nr1s, nr2s, nr3s values from input IMPORTANT: XC functional enforced from input : Exchange-correlation = SLA PZ NOGX NOGC ( 1 1 0 0 0) EXX-fraction = 0.00 Any further DFT definition will be discarded Please, verify this is what you really want file H.pz-vbc.UPF: wavefunction(s) 1S renormalized Parallelization info -------------------- sticks: dense smooth PW G-vecs: dense smooth PW Min 1787 1787 445 113964 113964 14262 Max 1790 1790 450 113970 113970 14264 Sum 7153 7153 1789 455863 455863 57051 Tot 3577 3577 895 Subspace diagonalization in iterative solution of the eigenvalue problem: a serial algorithm will be used Lanczos linear response spectrum calculation Number of Lanczos iterations = 500 Warning: There are virtual states in the input file, trying to disregard in response calculation Gamma point algorithm lr_wfcinit_spectrum: finished lr_solve_e Reading Pre-calculated lanczos coefficents from ./out/ch4-pr.beta_gamma_z.1 500 steps succesfully read for polarization index 1 Calculating response coefficients Resonance frequency mode enabled Charge Response renormalization factor: 0.25096E+05 0.00000E+00 Norm of initial Lanczos vectors= 1.841649869134100 Starting Lanczos loop 1 Lanczos iteration: 1 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal alpha(00000001)=0.000000000000000E+00 (calc=0.171988503139295E+01 read=0.171988503139295E+01) Weight for this step=-.74706E+00 -.25096E+02 beta (00000002)=0.171988503139295E+01 gamma(00000002)=0.171988503139295E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 2 z1= 1 0.124520334742597E+01 0.000000000000000E+00 z1= 2 0.317095473869808E-06 0.000000000000000E+00 z1= 3 0.663024993342767E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000002)=0.000000000000000E+00 (calc=0.476672689891552E+01 read=0.476672689891552E+01) Weight for this step=-.85118E+00 -.95520E+01 beta (00000003)=0.476672689891552E+01 gamma(00000003)=0.476672689891552E+01 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 3 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000003)=0.000000000000000E+00 (calc=0.135455819031628E+02 read=0.135455819031628E+02) Weight for this step=0.15466E+00 0.77428E+01 beta (00000004)=0.135455819031628E+02 gamma(00000004)=0.135455819031628E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 4 z1= 1 -.355940407651614E+00 0.000000000000000E+00 z1= 2 -.709929704697555E-07 0.000000000000000E+00 z1= 3 -.218015962744734E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000004)=0.000000000000000E+00 (calc=0.127184680928597E+02 read=0.127184680928597E+02) Weight for this step=0.30643E+00 0.37356E+01 beta (00000005)=0.127184680928597E+02 gamma(00000005)=0.127184680928597E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 5 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000005)=0.000000000000000E+00 (calc=0.134778713661835E+02 read=0.134778713661835E+02) Weight for this step=-.14924E+00 -.80541E+01 beta (00000006)=0.134778713661835E+02 gamma(00000006)=0.134778713661835E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 6 z1= 1 0.303456793894284E+00 0.000000000000000E+00 z1= 2 0.729994181687156E-07 0.000000000000000E+00 z1= 3 0.220826351416271E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000006)=0.000000000000000E+00 (calc=0.128879302219375E+02 read=0.128879302219375E+02) Weight for this step=-.29582E+00 -.39163E+01 beta (00000007)=0.128879302219375E+02 gamma(00000007)=0.128879302219375E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 7 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000007)=0.000000000000000E+00 (calc=0.133738472947644E+02 read=0.133738472947644E+02) Weight for this step=0.14135E+00 0.82238E+01 beta (00000008)=0.133738472947644E+02 gamma(00000008)=0.133738472947644E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 8 z1= 1 -.273899700042011E+00 0.000000000000000E+00 z1= 2 -.815998917591803E-07 0.000000000000000E+00 z1= 3 -.240121425991723E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000008)=0.000000000000000E+00 (calc=0.128588212197025E+02 read=0.128588212197025E+02) Weight for this step=0.29137E+00 0.41765E+01 beta (00000009)=0.128588212197025E+02 gamma(00000009)=0.128588212197025E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 9 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000009)=0.000000000000000E+00 (calc=0.134143943584606E+02 read=0.134143943584606E+02) Weight for this step=-.13250E+00 -.83406E+01 beta (00000010)=0.134143943584606E+02 gamma(00000010)=0.134143943584606E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 10 z1= 1 0.250161944170694E+00 0.000000000000000E+00 z1= 2 0.754143489895692E-07 0.000000000000000E+00 z1= 3 0.261006942501929E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000010)=0.000000000000000E+00 (calc=0.128242646105845E+02 read=0.128242646105845E+02) Weight for this step=-.28515E+00 -.44106E+01 beta (00000011)=0.128242646105845E+02 gamma(00000011)=0.128242646105845E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 11 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000011)=0.000000000000000E+00 (calc=0.134762987496952E+02 read=0.134762987496952E+02) Weight for this step=0.12439E+00 0.84992E+01 beta (00000012)=0.134762987496952E+02 gamma(00000012)=0.134762987496952E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 12 z1= 1 -.228558099805471E+00 0.000000000000000E+00 z1= 2 -.686414724877446E-07 0.000000000000000E+00 z1= 3 -.281781214916195E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000012)=0.000000000000000E+00 (calc=0.128064510567046E+02 read=0.128064510567046E+02) Weight for this step=0.27677E+00 0.46100E+01 beta (00000013)=0.128064510567046E+02 gamma(00000013)=0.128064510567046E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 13 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000013)=0.000000000000000E+00 (calc=0.134982211612641E+02 read=0.134982211612641E+02) Weight for this step=-.11711E+00 -.87081E+01 beta (00000014)=0.134982211612641E+02 gamma(00000014)=0.134982211612641E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 14 z1= 1 0.209175389896875E+00 0.000000000000000E+00 z1= 2 0.779110487293157E-07 0.000000000000000E+00 z1= 3 0.297441224358767E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000014)=0.000000000000000E+00 (calc=0.128005701597246E+02 read=0.128005701597246E+02) Weight for this step=-.26762E+00 -.47961E+01 beta (00000015)=0.128005701597246E+02 gamma(00000015)=0.128005701597246E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 15 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000015)=0.000000000000000E+00 (calc=0.134714904807318E+02 read=0.134714904807318E+02) Weight for this step=0.11018E+00 0.89374E+01 beta (00000016)=0.134714904807318E+02 gamma(00000016)=0.134714904807318E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 16 z1= 1 -.192296691151057E+00 0.000000000000000E+00 z1= 2 -.953196138929469E-07 0.000000000000000E+00 z1= 3 -.303704543073730E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000016)=0.000000000000000E+00 (calc=0.127887193302416E+02 read=0.127887193302416E+02) Weight for this step=0.25898E+00 0.49915E+01 beta (00000017)=0.127887193302416E+02 gamma(00000017)=0.127887193302416E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 17 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000017)=0.000000000000000E+00 (calc=0.134266175648045E+02 read=0.134266175648045E+02) Weight for this step=-.10320E+00 -.91591E+01 beta (00000018)=0.134266175648045E+02 gamma(00000018)=0.134266175648045E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 18 z1= 1 0.177688165637444E+00 0.000000000000000E+00 z1= 2 0.113911880913163E-06 0.000000000000000E+00 z1= 3 0.300714177139580E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000018)=0.000000000000000E+00 (calc=0.127825615153248E+02 read=0.127825615153248E+02) Weight for this step=-.25102E+00 -.52009E+01 beta (00000019)=0.127825615153248E+02 gamma(00000019)=0.127825615153248E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 19 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000019)=0.000000000000000E+00 (calc=0.134080225014896E+02 read=0.134080225014896E+02) Weight for this step=0.95949E-01 0.93542E+01 beta (00000020)=0.134080225014896E+02 gamma(00000020)=0.134080225014896E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 20 z1= 1 -.164706328023573E+00 0.000000000000000E+00 z1= 2 -.146703496893465E-06 0.000000000000000E+00 z1= 3 -.298789065428099E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000020)=0.000000000000000E+00 (calc=0.128007405891743E+02 read=0.128007405891743E+02) Weight for this step=0.24330E+00 0.54150E+01 beta (00000021)=0.128007405891743E+02 gamma(00000021)=0.128007405891743E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 21 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000021)=0.000000000000000E+00 (calc=0.134207199429619E+02 read=0.134207199429619E+02) Weight for this step=-.88482E-01 -.95211E+01 beta (00000022)=0.134207199429619E+02 gamma(00000022)=0.134207199429619E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 22 z1= 1 0.153072725164172E+00 0.000000000000000E+00 z1= 2 0.167000018543029E-06 0.000000000000000E+00 z1= 3 0.288819380002848E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000022)=0.000000000000000E+00 (calc=0.128225843350253E+02 read=0.128225843350253E+02) Weight for this step=-.23567E+00 -.56292E+01 beta (00000023)=0.128225843350253E+02 gamma(00000023)=0.128225843350253E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 23 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000023)=0.000000000000000E+00 (calc=0.134332985047371E+02 read=0.134332985047371E+02) Weight for this step=0.81017E-01 0.96778E+01 beta (00000024)=0.134332985047371E+02 gamma(00000024)=0.134332985047371E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 24 z1= 1 -.142653586426500E+00 0.000000000000000E+00 z1= 2 -.176769482250223E-06 0.000000000000000E+00 z1= 3 -.279483744428143E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000024)=0.000000000000000E+00 (calc=0.128311412750717E+02 read=0.128311412750717E+02) Weight for this step=0.22818E+00 0.58449E+01 beta (00000025)=0.128311412750717E+02 gamma(00000025)=0.128311412750717E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 25 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000025)=0.000000000000000E+00 (calc=0.134383835925919E+02 read=0.134383835925919E+02) Weight for this step=-.73634E-01 -.98338E+01 beta (00000026)=0.134383835925919E+02 gamma(00000026)=0.134383835925919E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 26 z1= 1 0.133198511431655E+00 0.000000000000000E+00 z1= 2 0.183945885238578E-06 0.000000000000000E+00 z1= 3 0.294017734448696E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000026)=0.000000000000000E+00 (calc=0.128182255125753E+02 read=0.128182255125753E+02) Weight for this step=-.22072E+00 -.60598E+01 beta (00000027)=0.128182255125753E+02 gamma(00000027)=0.128182255125753E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 27 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000027)=0.000000000000000E+00 (calc=0.134102256464240E+02 read=0.134102256464240E+02) Weight for this step=0.66397E-01 0.10000E+02 beta (00000028)=0.134102256464240E+02 gamma(00000028)=0.134102256464240E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 28 z1= 1 -.124698046392641E+00 0.000000000000000E+00 z1= 2 -.178587660683120E-06 0.000000000000000E+00 z1= 3 -.320817650230451E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000028)=0.000000000000000E+00 (calc=0.127846778652988E+02 read=0.127846778652988E+02) Weight for this step=0.21348E+00 0.62804E+01 beta (00000029)=0.127846778652988E+02 gamma(00000029)=0.127846778652988E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 29 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000029)=0.000000000000000E+00 (calc=0.134134228273156E+02 read=0.134134228273156E+02) Weight for this step=-.59207E-01 -.10168E+02 beta (00000030)=0.134134228273156E+02 gamma(00000030)=0.134134228273156E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 30 z1= 1 0.116544736685154E+00 0.000000000000000E+00 z1= 2 0.165167278937117E-06 0.000000000000000E+00 z1= 3 0.338408872945384E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000030)=0.000000000000000E+00 (calc=0.128191527329623E+02 read=0.128191527329623E+02) Weight for this step=-.20560E+00 -.64823E+01 beta (00000031)=0.128191527329623E+02 gamma(00000031)=0.128191527329623E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 31 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000031)=0.000000000000000E+00 (calc=0.134294009228354E+02 read=0.134294009228354E+02) Weight for this step=0.51958E-01 0.10308E+02 beta (00000032)=0.134294009228354E+02 gamma(00000032)=0.134294009228354E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 32 z1= 1 -.109214203792739E+00 0.000000000000000E+00 z1= 2 -.148961257963581E-06 0.000000000000000E+00 z1= 3 -.341636058890564E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000032)=0.000000000000000E+00 (calc=0.127671183314944E+02 read=0.127671183314944E+02) Weight for this step=0.19802E+00 0.66902E+01 beta (00000033)=0.127671183314944E+02 gamma(00000033)=0.127671183314944E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 33 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000033)=0.000000000000000E+00 (calc=0.133586624070168E+02 read=0.133586624070168E+02) Weight for this step=-.45025E-01 -.10500E+02 beta (00000034)=0.133586624070168E+02 gamma(00000034)=0.133586624070168E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 34 z1= 1 0.102543468595489E+00 0.000000000000000E+00 z1= 2 0.126861167013166E-06 0.000000000000000E+00 z1= 3 0.350387747672981E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000034)=0.000000000000000E+00 (calc=0.127703274763539E+02 read=0.127703274763539E+02) Weight for this step=-.19067E+00 -.69084E+01 beta (00000035)=0.127703274763539E+02 gamma(00000035)=0.127703274763539E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 35 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000035)=0.000000000000000E+00 (calc=0.134311106659527E+02 read=0.134311106659527E+02) Weight for this step=0.37866E-01 0.10629E+02 beta (00000036)=0.134311106659527E+02 gamma(00000036)=0.134311106659527E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 36 z1= 1 -.958466447694731E-01 0.000000000000000E+00 z1= 2 -.104730672858926E-06 0.000000000000000E+00 z1= 3 -.356673057850415E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000036)=0.000000000000000E+00 (calc=0.128060606184881E+02 read=0.128060606184881E+02) Weight for this step=0.18235E+00 0.70866E+01 beta (00000037)=0.128060606184881E+02 gamma(00000037)=0.128060606184881E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 37 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000037)=0.000000000000000E+00 (calc=0.133888972899599E+02 read=0.133888972899599E+02) Weight for this step=-.30947E-01 -.10786E+02 beta (00000038)=0.133888972899599E+02 gamma(00000038)=0.133888972899599E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 38 z1= 1 0.901622998431228E-01 0.000000000000000E+00 z1= 2 0.872973411648881E-07 0.000000000000000E+00 z1= 3 0.361186554502253E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000038)=0.000000000000000E+00 (calc=0.127549634132078E+02 read=0.127549634132078E+02) Weight for this step=-.17512E+00 -.73054E+01 beta (00000039)=0.127549634132078E+02 gamma(00000039)=0.127549634132078E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 39 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000039)=0.000000000000000E+00 (calc=0.133497045369355E+02 read=0.133497045369355E+02) Weight for this step=0.24070E-01 0.10947E+02 beta (00000040)=0.133497045369355E+02 gamma(00000040)=0.133497045369355E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 40 z1= 1 -.847497650868138E-01 0.000000000000000E+00 z1= 2 -.698850330530312E-07 0.000000000000000E+00 z1= 3 -.360351918143311E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000040)=0.000000000000000E+00 (calc=0.126995463382604E+02 read=0.126995463382604E+02) Weight for this step=0.16768E+00 0.75168E+01 beta (00000041)=0.126995463382604E+02 gamma(00000041)=0.126995463382604E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 41 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000041)=0.000000000000000E+00 (calc=0.133246757767513E+02 read=0.133246757767513E+02) Weight for this step=-.17252E-01 -.11120E+02 beta (00000042)=0.133246757767513E+02 gamma(00000042)=0.133246757767513E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 42 z1= 1 0.794592930098019E-01 0.000000000000000E+00 z1= 2 0.498799826650909E-07 0.000000000000000E+00 z1= 3 0.353790508667994E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000042)=0.000000000000000E+00 (calc=0.127528421613253E+02 read=0.127528421613253E+02) Weight for this step=-.15982E+00 -.77104E+01 beta (00000043)=0.127528421613253E+02 gamma(00000043)=0.127528421613253E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 43 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000043)=0.000000000000000E+00 (calc=0.133691963700601E+02 read=0.133691963700601E+02) Weight for this step=0.10426E-01 0.11223E+02 beta (00000044)=0.133691963700601E+02 gamma(00000044)=0.133691963700601E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 44 z1= 1 -.746049876802575E-01 0.000000000000000E+00 z1= 2 -.292785169962728E-07 0.000000000000000E+00 z1= 3 -.361153975821072E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000044)=0.000000000000000E+00 (calc=0.127653035729734E+02 read=0.127653035729734E+02) Weight for this step=0.15213E+00 0.79045E+01 beta (00000045)=0.127653035729734E+02 gamma(00000045)=0.127653035729734E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 45 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000045)=0.000000000000000E+00 (calc=0.134072306591372E+02 read=0.134072306591372E+02) Weight for this step=-.37375E-02 -.11348E+02 beta (00000046)=0.134072306591372E+02 gamma(00000046)=0.134072306591372E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 46 z1= 1 0.699088962063403E-01 0.000000000000000E+00 z1= 2 0.171631698367425E-07 0.000000000000000E+00 z1= 3 0.365421957649052E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000046)=0.000000000000000E+00 (calc=0.127671150895094E+02 read=0.127671150895094E+02) Weight for this step=-.14418E+00 -.80801E+01 beta (00000047)=0.127671150895094E+02 gamma(00000047)=0.127671150895094E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 47 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000047)=0.000000000000000E+00 (calc=0.133557571069238E+02 read=0.133557571069238E+02) Weight for this step=-.28346E-02 0.11503E+02 beta (00000048)=0.133557571069238E+02 gamma(00000048)=0.133557571069238E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 48 z1= 1 -.657697202050140E-01 0.000000000000000E+00 z1= 2 -.169263177519224E-07 0.000000000000000E+00 z1= 3 -.360485822769306E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000048)=0.000000000000000E+00 (calc=0.128436214001654E+02 read=0.128436214001654E+02) Weight for this step=0.13682E+00 0.82877E+01 beta (00000049)=0.128436214001654E+02 gamma(00000049)=0.128436214001654E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 49 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000049)=0.000000000000000E+00 (calc=0.134358308295089E+02 read=0.134358308295089E+02) Weight for this step=0.92758E-02 -.11539E+02 beta (00000050)=0.134358308295089E+02 gamma(00000050)=0.134358308295089E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 50 z1= 1 0.619290029441438E-01 0.000000000000000E+00 z1= 2 0.248484081167080E-07 0.000000000000000E+00 z1= 3 0.362231282321807E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000050)=0.000000000000000E+00 (calc=0.126967568416403E+02 read=0.126967568416403E+02) Weight for this step=-.12948E+00 -.84847E+01 beta (00000051)=0.126967568416403E+02 gamma(00000051)=0.126967568416403E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 51 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000051)=0.000000000000000E+00 (calc=0.132891123293467E+02 read=0.132891123293467E+02) Weight for this step=-.15823E-01 0.11774E+02 beta (00000052)=0.132891123293467E+02 gamma(00000052)=0.132891123293467E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 52 z1= 1 -.582333860549248E-01 0.000000000000000E+00 z1= 2 -.378424913974329E-07 0.000000000000000E+00 z1= 3 -.376054178413991E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000052)=0.000000000000000E+00 (calc=0.127443370501644E+02 read=0.127443370501644E+02) Weight for this step=0.12204E+00 0.86864E+01 beta (00000053)=0.127443370501644E+02 gamma(00000053)=0.127443370501644E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 53 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000053)=0.000000000000000E+00 (calc=0.133131464409104E+02 read=0.133131464409104E+02) Weight for this step=0.22087E-01 -.11831E+02 beta (00000054)=0.133131464409104E+02 gamma(00000054)=0.133131464409104E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 54 z1= 1 0.549111851559616E-01 0.000000000000000E+00 z1= 2 0.461414481267228E-07 0.000000000000000E+00 z1= 3 0.386736516825616E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000054)=0.000000000000000E+00 (calc=0.127443546610177E+02 read=0.127443546610177E+02) Weight for this step=-.11486E+00 -.88970E+01 beta (00000055)=0.127443546610177E+02 gamma(00000055)=0.127443546610177E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 55 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000055)=0.000000000000000E+00 (calc=0.133785355807721E+02 read=0.133785355807721E+02) Weight for this step=-.28274E-01 0.11902E+02 beta (00000056)=0.133785355807721E+02 gamma(00000056)=0.133785355807721E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 56 z1= 1 -.515459520943306E-01 0.000000000000000E+00 z1= 2 -.679827492494622E-07 0.000000000000000E+00 z1= 3 -.386984238694892E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000056)=0.000000000000000E+00 (calc=0.128320509799064E+02 read=0.128320509799064E+02) Weight for this step=0.10714E+00 0.90576E+01 beta (00000057)=0.128320509799064E+02 gamma(00000057)=0.128320509799064E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 57 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000057)=0.000000000000000E+00 (calc=0.134459854309694E+02 read=0.134459854309694E+02) Weight for this step=0.34237E-01 -.11947E+02 beta (00000058)=0.134459854309694E+02 gamma(00000058)=0.134459854309694E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 58 z1= 1 0.484730003324594E-01 0.000000000000000E+00 z1= 2 0.919850068614725E-07 0.000000000000000E+00 z1= 3 0.390154895056160E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000058)=0.000000000000000E+00 (calc=0.127464084135541E+02 read=0.127464084135541E+02) Weight for this step=-.99691E-01 -.92256E+01 beta (00000059)=0.127464084135541E+02 gamma(00000059)=0.127464084135541E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 59 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000059)=0.000000000000000E+00 (calc=0.133328228271439E+02 read=0.133328228271439E+02) Weight for this step=-.40512E-01 0.12128E+02 beta (00000060)=0.133328228271439E+02 gamma(00000060)=0.133328228271439E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 60 z1= 1 -.457059357858629E-01 0.000000000000000E+00 z1= 2 -.109054515946318E-06 0.000000000000000E+00 z1= 3 -.401171588826506E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000060)=0.000000000000000E+00 (calc=0.128405797787776E+02 read=0.128405797787776E+02) Weight for this step=0.92408E-01 0.94153E+01 beta (00000061)=0.128405797787776E+02 gamma(00000061)=0.128405797787776E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 61 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000061)=0.000000000000000E+00 (calc=0.133760314900567E+02 read=0.133760314900567E+02) Weight for this step=0.46043E-01 -.12113E+02 beta (00000062)=0.133760314900567E+02 gamma(00000062)=0.133760314900567E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 62 z1= 1 0.432735976409498E-01 0.000000000000000E+00 z1= 2 0.119604457324285E-06 0.000000000000000E+00 z1= 3 0.409826960902902E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000062)=0.000000000000000E+00 (calc=0.128441819570853E+02 read=0.128441819570853E+02) Weight for this step=-.85550E-01 -.96312E+01 beta (00000063)=0.128441819570853E+02 gamma(00000063)=0.128441819570853E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 63 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000063)=0.000000000000000E+00 (calc=0.134459510950132E+02 read=0.134459510950132E+02) Weight for this step=-.51560E-01 0.12124E+02 beta (00000064)=0.134459510950132E+02 gamma(00000064)=0.134459510950132E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 64 z1= 1 -.408083948244251E-01 0.000000000000000E+00 z1= 2 -.131299869132566E-06 0.000000000000000E+00 z1= 3 -.411239326868619E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000064)=0.000000000000000E+00 (calc=0.128237674446673E+02 read=0.128237674446673E+02) Weight for this step=0.78309E-01 0.97904E+01 beta (00000065)=0.128237674446673E+02 gamma(00000065)=0.128237674446673E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 65 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000065)=0.000000000000000E+00 (calc=0.134804256863556E+02 read=0.134804256863556E+02) Weight for this step=0.57295E-01 -.12213E+02 beta (00000066)=0.134804256863556E+02 gamma(00000066)=0.134804256863556E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 66 z1= 1 0.383599128533590E-01 0.000000000000000E+00 z1= 2 0.149659896592734E-06 0.000000000000000E+00 z1= 3 0.407150572080315E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000066)=0.000000000000000E+00 (calc=0.128621045629678E+02 read=0.128621045629678E+02) Weight for this step=-.70806E-01 -.99065E+01 beta (00000067)=0.128621045629678E+02 gamma(00000067)=0.128621045629678E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 67 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000067)=0.000000000000000E+00 (calc=0.133881841148913E+02 read=0.133881841148913E+02) Weight for this step=-.62883E-01 0.12296E+02 beta (00000068)=0.133881841148913E+02 gamma(00000068)=0.133881841148913E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 68 z1= 1 -.364110885210623E-01 0.000000000000000E+00 z1= 2 -.163525031293688E-06 0.000000000000000E+00 z1= 3 -.409185854252604E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000068)=0.000000000000000E+00 (calc=0.128152870789198E+02 read=0.128152870789198E+02) Weight for this step=0.64031E-01 0.10118E+02 beta (00000069)=0.128152870789198E+02 gamma(00000069)=0.128152870789198E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 69 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000069)=0.000000000000000E+00 (calc=0.133445173694389E+02 read=0.133445173694389E+02) Weight for this step=0.68175E-01 -.12328E+02 beta (00000070)=0.133445173694389E+02 gamma(00000070)=0.133445173694389E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 70 z1= 1 0.345808815868468E-01 0.000000000000000E+00 z1= 2 0.173594340459673E-06 0.000000000000000E+00 z1= 3 0.411957077036621E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000070)=0.000000000000000E+00 (calc=0.128069647934933E+02 read=0.128069647934933E+02) Weight for this step=-.57224E-01 -.10322E+02 beta (00000071)=0.128069647934933E+02 gamma(00000071)=0.128069647934933E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 71 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000071)=0.000000000000000E+00 (calc=0.134042168562389E+02 read=0.134042168562389E+02) Weight for this step=-.73156E-01 0.12318E+02 beta (00000072)=0.134042168562389E+02 gamma(00000072)=0.134042168562389E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 72 z1= 1 -.326965735084420E-01 0.000000000000000E+00 z1= 2 -.178560453403288E-06 0.000000000000000E+00 z1= 3 -.408650682143068E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000072)=0.000000000000000E+00 (calc=0.128627096044086E+02 read=0.128627096044086E+02) Weight for this step=0.50182E-01 0.10464E+02 beta (00000073)=0.128627096044086E+02 gamma(00000073)=0.128627096044086E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 73 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000073)=0.000000000000000E+00 (calc=0.133230432815588E+02 read=0.133230432815588E+02) Weight for this step=0.77976E-01 -.12304E+02 beta (00000074)=0.133230432815588E+02 gamma(00000074)=0.133230432815588E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 74 z1= 1 0.313034850138304E-01 0.000000000000000E+00 z1= 2 0.184907473136861E-06 0.000000000000000E+00 z1= 3 0.401747916617770E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000074)=0.000000000000000E+00 (calc=0.127141928431595E+02 read=0.127141928431595E+02) Weight for this step=-.43694E-01 -.10707E+02 beta (00000075)=0.127141928431595E+02 gamma(00000075)=0.127141928431595E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 75 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000075)=0.000000000000000E+00 (calc=0.133868796839417E+02 read=0.133868796839417E+02) Weight for this step=-.83117E-01 0.12342E+02 beta (00000076)=0.133868796839417E+02 gamma(00000076)=0.133868796839417E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 76 z1= 1 -.294635617187391E-01 0.000000000000000E+00 z1= 2 -.193991977012579E-06 0.000000000000000E+00 z1= 3 -.388508151522092E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000076)=0.000000000000000E+00 (calc=0.127641760123857E+02 read=0.127641760123857E+02) Weight for this step=0.36512E-01 0.10772E+02 beta (00000077)=0.127641760123857E+02 gamma(00000077)=0.127641760123857E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 77 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000077)=0.000000000000000E+00 (calc=0.133755104004219E+02 read=0.133755104004219E+02) Weight for this step=0.88201E-01 -.12392E+02 beta (00000078)=0.133755104004219E+02 gamma(00000078)=0.133755104004219E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 78 z1= 1 0.278745168460386E-01 0.000000000000000E+00 z1= 2 0.212422699508944E-06 0.000000000000000E+00 z1= 3 0.375631066757711E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000078)=0.000000000000000E+00 (calc=0.128262857218772E+02 read=0.128262857218772E+02) Weight for this step=-.29600E-01 -.10886E+02 beta (00000079)=0.128262857218772E+02 gamma(00000079)=0.128262857218772E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 79 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000079)=0.000000000000000E+00 (calc=0.133316289379736E+02 read=0.133316289379736E+02) Weight for this step=-.92639E-01 0.12367E+02 beta (00000080)=0.133316289379736E+02 gamma(00000080)=0.133316289379736E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 80 z1= 1 -.266559155780984E-01 0.000000000000000E+00 z1= 2 -.238117507457385E-06 0.000000000000000E+00 z1= 3 -.369276508401200E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000080)=0.000000000000000E+00 (calc=0.127857332877510E+02 read=0.127857332877510E+02) Weight for this step=0.23002E-01 0.11081E+02 beta (00000081)=0.127857332877510E+02 gamma(00000081)=0.127857332877510E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 81 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000081)=0.000000000000000E+00 (calc=0.133994473968668E+02 read=0.133994473968668E+02) Weight for this step=0.96906E-01 -.12328E+02 beta (00000082)=0.133994473968668E+02 gamma(00000082)=0.133994473968668E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 82 z1= 1 0.253064284142861E-01 0.000000000000000E+00 z1= 2 0.261380404619795E-06 0.000000000000000E+00 z1= 3 0.371455303559815E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000082)=0.000000000000000E+00 (calc=0.128397009602121E+02 read=0.128397009602121E+02) Weight for this step=-.16294E-01 -.11175E+02 beta (00000083)=0.128397009602121E+02 gamma(00000083)=0.128397009602121E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 83 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000083)=0.000000000000000E+00 (calc=0.133717645673665E+02 read=0.133717645673665E+02) Weight for this step=-.10109E+00 0.12295E+02 beta (00000084)=0.133717645673665E+02 gamma(00000084)=0.133717645673665E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 84 z1= 1 -.241730284748381E-01 0.000000000000000E+00 z1= 2 -.299696386524880E-06 0.000000000000000E+00 z1= 3 -.374374016104580E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000084)=0.000000000000000E+00 (calc=0.128117725606991E+02 read=0.128117725606991E+02) Weight for this step=0.97774E-02 0.11333E+02 beta (00000085)=0.128117725606991E+02 gamma(00000085)=0.128117725606991E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 85 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000085)=0.000000000000000E+00 (calc=0.133218180294894E+02 read=0.133218180294894E+02) Weight for this step=0.10512E+00 -.12254E+02 beta (00000086)=0.133218180294894E+02 gamma(00000086)=0.133218180294894E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 86 z1= 1 0.231490293142133E-01 0.000000000000000E+00 z1= 2 0.339228402274766E-06 0.000000000000000E+00 z1= 3 0.372596752148350E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000086)=0.000000000000000E+00 (calc=0.127545881229632E+02 read=0.127545881229632E+02) Weight for this step=-.33177E-02 -.11501E+02 beta (00000087)=0.127545881229632E+02 gamma(00000087)=0.127545881229632E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 87 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000087)=0.000000000000000E+00 (calc=0.133435623731637E+02 read=0.133435623731637E+02) Weight for this step=-.10907E+00 0.12208E+02 beta (00000088)=0.133435623731637E+02 gamma(00000088)=0.133435623731637E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 88 z1= 1 -.220542256993823E-01 0.000000000000000E+00 z1= 2 -.372447332871485E-06 0.000000000000000E+00 z1= 3 -.376408738842534E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000088)=0.000000000000000E+00 (calc=0.128929978347644E+02 read=0.128929978347644E+02) Weight for this step=-.30943E-02 0.11592E+02 beta (00000089)=0.128929978347644E+02 gamma(00000089)=0.128929978347644E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 89 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000089)=0.000000000000000E+00 (calc=0.133924342711202E+02 read=0.133924342711202E+02) Weight for this step=0.11182E+00 -.12047E+02 beta (00000090)=0.133924342711202E+02 gamma(00000090)=0.133924342711202E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 90 z1= 1 0.211832396067604E-01 0.000000000000000E+00 z1= 2 0.407698566206628E-06 0.000000000000000E+00 z1= 3 0.379785358992687E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000090)=0.000000000000000E+00 (calc=0.126659751874259E+02 read=0.126659751874259E+02) Weight for this step=0.93441E-02 -.11749E+02 beta (00000091)=0.126659751874259E+02 gamma(00000091)=0.126659751874259E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 91 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000091)=0.000000000000000E+00 (calc=0.133458506592244E+02 read=0.133458506592244E+02) Weight for this step=-.11683E+00 0.12130E+02 beta (00000092)=0.133458506592244E+02 gamma(00000092)=0.133458506592244E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 92 z1= 1 -.200863094562753E-01 0.000000000000000E+00 z1= 2 -.422209001283216E-06 0.000000000000000E+00 z1= 3 -.379739547237473E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000092)=0.000000000000000E+00 (calc=0.127909396681337E+02 read=0.127909396681337E+02) Weight for this step=-.15507E-01 0.11745E+02 beta (00000093)=0.127909396681337E+02 gamma(00000093)=0.127909396681337E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 93 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000093)=0.000000000000000E+00 (calc=0.133461370256088E+02 read=0.133461370256088E+02) Weight for this step=0.12018E+00 -.12055E+02 beta (00000094)=0.133461370256088E+02 gamma(00000094)=0.133461370256088E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 94 z1= 1 0.192789146028386E-01 0.000000000000000E+00 z1= 2 0.451995666492667E-06 0.000000000000000E+00 z1= 3 0.381795591011726E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000094)=0.000000000000000E+00 (calc=0.127865790820774E+02 read=0.127865790820774E+02) Weight for this step=0.21660E-01 -.11848E+02 beta (00000095)=0.127865790820774E+02 gamma(00000095)=0.127865790820774E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 95 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000095)=0.000000000000000E+00 (calc=0.133901013045594E+02 read=0.133901013045594E+02) Weight for this step=-.12341E+00 0.11976E+02 beta (00000096)=0.133901013045594E+02 gamma(00000096)=0.133901013045594E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 96 z1= 1 -.184169131545688E-01 0.000000000000000E+00 z1= 2 -.478292122980690E-06 0.000000000000000E+00 z1= 3 -.382151120809874E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000096)=0.000000000000000E+00 (calc=0.127921043564931E+02 read=0.127921043564931E+02) Weight for this step=-.27611E-01 0.11899E+02 beta (00000097)=0.127921043564931E+02 gamma(00000097)=0.127921043564931E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 97 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000097)=0.000000000000000E+00 (calc=0.134509416191960E+02 read=0.134509416191960E+02) Weight for this step=0.12683E+00 -.11927E+02 beta (00000098)=0.134509416191960E+02 gamma(00000098)=0.134509416191960E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 98 z1= 1 0.175090571805012E-01 0.000000000000000E+00 z1= 2 0.494523929528640E-06 0.000000000000000E+00 z1= 3 0.373427974641042E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000098)=0.000000000000000E+00 (calc=0.130150727959673E+02 read=0.130150727959673E+02) Weight for this step=0.33318E-01 -.11897E+02 beta (00000099)=0.130150727959673E+02 gamma(00000099)=0.130150727959673E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 99 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000099)=0.000000000000000E+00 (calc=0.136149108908864E+02 read=0.136149108908864E+02) Weight for this step=-.12849E+00 0.11729E+02 beta (00000100)=0.136149108908864E+02 gamma(00000100)=0.136149108908864E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 100 z1= 1 -.167546599094435E-01 0.000000000000000E+00 z1= 2 -.515944896707730E-06 0.000000000000000E+00 z1= 3 -.363981079026690E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000100)=0.000000000000000E+00 (calc=0.127969559962275E+02 read=0.127969559962275E+02) Weight for this step=-.38889E-01 0.11937E+02 beta (00000101)=0.127969559962275E+02 gamma(00000101)=0.127969559962275E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 101 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000101)=0.000000000000000E+00 (calc=0.132882480514421E+02 read=0.132882480514421E+02) Weight for this step=0.13378E+00 -.11868E+02 beta (00000102)=0.132882480514421E+02 gamma(00000102)=0.132882480514421E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 102 z1= 1 0.161797853175664E-01 0.000000000000000E+00 z1= 2 0.541037899586417E-06 0.000000000000000E+00 z1= 3 0.353270947228576E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000102)=0.000000000000000E+00 (calc=0.128815690606503E+02 read=0.128815690606503E+02) Weight for this step=0.44935E-01 -.12080E+02 beta (00000103)=0.128815690606503E+02 gamma(00000103)=0.128815690606503E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 103 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000103)=0.000000000000000E+00 (calc=0.134147767602552E+02 read=0.134147767602552E+02) Weight for this step=-.13478E+00 0.11628E+02 beta (00000104)=0.134147767602552E+02 gamma(00000104)=0.134147767602552E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 104 z1= 1 -.156273509690295E-01 0.000000000000000E+00 z1= 2 -.562747698651216E-06 0.000000000000000E+00 z1= 3 -.336098349603341E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000104)=0.000000000000000E+00 (calc=0.128778633941098E+02 read=0.128778633941098E+02) Weight for this step=-.50593E-01 0.12167E+02 beta (00000105)=0.128778633941098E+02 gamma(00000105)=0.128778633941098E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 105 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000105)=0.000000000000000E+00 (calc=0.132659013390477E+02 read=0.132659013390477E+02) Weight for this step=0.13689E+00 -.11495E+02 beta (00000106)=0.132659013390477E+02 gamma(00000106)=0.132659013390477E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 106 z1= 1 0.152718966176220E-01 0.000000000000000E+00 z1= 2 0.593543796829302E-06 0.000000000000000E+00 z1= 3 0.327044875926921E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000106)=0.000000000000000E+00 (calc=0.126949465550008E+02 read=0.126949465550008E+02) Weight for this step=0.56734E-01 -.12379E+02 beta (00000107)=0.126949465550008E+02 gamma(00000107)=0.126949465550008E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 107 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000107)=0.000000000000000E+00 (calc=0.133395812580347E+02 read=0.133395812580347E+02) Weight for this step=-.13914E+00 0.11373E+02 beta (00000108)=0.133395812580347E+02 gamma(00000108)=0.133395812580347E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 108 z1= 1 -.145899325244997E-01 0.000000000000000E+00 z1= 2 -.620122297296860E-06 0.000000000000000E+00 z1= 3 -.308050886246007E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000108)=0.000000000000000E+00 (calc=0.128482756775422E+02 read=0.128482756775422E+02) Weight for this step=-.61673E-01 0.12338E+02 beta (00000109)=0.128482756775422E+02 gamma(00000109)=0.128482756775422E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 109 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000109)=0.000000000000000E+00 (calc=0.133217660866958E+02 read=0.133217660866958E+02) Weight for this step=0.14036E+00 -.11180E+02 beta (00000110)=0.133217660866958E+02 gamma(00000110)=0.133217660866958E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 110 z1= 1 0.141244534499666E-01 0.000000000000000E+00 z1= 2 0.654443013286101E-06 0.000000000000000E+00 z1= 3 0.283682922115136E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000110)=0.000000000000000E+00 (calc=0.126967122960627E+02 read=0.126967122960627E+02) Weight for this step=0.67217E-01 -.12449E+02 beta (00000111)=0.126967122960627E+02 gamma(00000111)=0.126967122960627E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 111 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000111)=0.000000000000000E+00 (calc=0.135206893788410E+02 read=0.135206893788410E+02) Weight for this step=-.14282E+00 0.11088E+02 beta (00000112)=0.135206893788410E+02 gamma(00000112)=0.135206893788410E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 112 z1= 1 -.133226919265497E-01 0.000000000000000E+00 z1= 2 -.682140455631397E-06 0.000000000000000E+00 z1= 3 -.256899064049357E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000112)=0.000000000000000E+00 (calc=0.129787488450375E+02 read=0.129787488450375E+02) Weight for this step=-.70855E-01 0.12227E+02 beta (00000113)=0.129787488450375E+02 gamma(00000113)=0.129787488450375E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 113 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000113)=0.000000000000000E+00 (calc=0.134371970739290E+02 read=0.134371970739290E+02) Weight for this step=0.14427E+00 -.10935E+02 beta (00000114)=0.134371970739290E+02 gamma(00000114)=0.134371970739290E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 114 z1= 1 0.129009766881108E-01 0.000000000000000E+00 z1= 2 0.730484093333129E-06 0.000000000000000E+00 z1= 3 0.244673875214249E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000114)=0.000000000000000E+00 (calc=0.127033501149243E+02 read=0.127033501149243E+02) Weight for this step=0.76280E-01 -.12343E+02 beta (00000115)=0.127033501149243E+02 gamma(00000115)=0.127033501149243E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 115 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000115)=0.000000000000000E+00 (calc=0.135069835315474E+02 read=0.135069835315474E+02) Weight for this step=-.14770E+00 0.10930E+02 beta (00000116)=0.135069835315474E+02 gamma(00000116)=0.135069835315474E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 116 z1= 1 -.122153982732531E-01 0.000000000000000E+00 z1= 2 -.761271567508446E-06 0.000000000000000E+00 z1= 3 -.219950388937341E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000116)=0.000000000000000E+00 (calc=0.127083381806927E+02 read=0.127083381806927E+02) Weight for this step=-.79709E-01 0.12138E+02 beta (00000117)=0.127083381806927E+02 gamma(00000117)=0.127083381806927E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 117 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000117)=0.000000000000000E+00 (calc=0.132506528564081E+02 read=0.132506528564081E+02) Weight for this step=0.15193E+00 -.10992E+02 beta (00000118)=0.132506528564081E+02 gamma(00000118)=0.132506528564081E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 118 z1= 1 0.118296558816171E-01 0.000000000000000E+00 z1= 2 0.814191366080991E-06 0.000000000000000E+00 z1= 3 0.200055966118680E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000118)=0.000000000000000E+00 (calc=0.127948306212576E+02 read=0.127948306212576E+02) Weight for this step=0.84782E-01 -.12184E+02 beta (00000119)=0.127948306212576E+02 gamma(00000119)=0.127948306212576E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 119 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000119)=0.000000000000000E+00 (calc=0.133198404294845E+02 read=0.133198404294845E+02) Weight for this step=-.15205E+00 0.10760E+02 beta (00000120)=0.133198404294845E+02 gamma(00000120)=0.133198404294845E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 120 z1= 1 -.114614482339868E-01 0.000000000000000E+00 z1= 2 -.855740453520239E-06 0.000000000000000E+00 z1= 3 -.179737052205726E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000120)=0.000000000000000E+00 (calc=0.125251007130107E+02 read=0.125251007130107E+02) Weight for this step=-.89720E-01 0.12233E+02 beta (00000121)=0.125251007130107E+02 gamma(00000121)=0.125251007130107E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 121 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000121)=0.000000000000000E+00 (calc=0.131931003578598E+02 read=0.131931003578598E+02) Weight for this step=0.15603E+00 -.10804E+02 beta (00000122)=0.131931003578598E+02 gamma(00000122)=0.131931003578598E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 122 z1= 1 0.109867078190985E-01 0.000000000000000E+00 z1= 2 0.883526422909304E-06 0.000000000000000E+00 z1= 3 0.157090489706364E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000122)=0.000000000000000E+00 (calc=0.127053182443001E+02 read=0.127053182443001E+02) Weight for this step=0.93738E-01 -.12150E+02 beta (00000123)=0.127053182443001E+02 gamma(00000123)=0.127053182443001E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 123 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000123)=0.000000000000000E+00 (calc=0.133819590475111E+02 read=0.133819590475111E+02) Weight for this step=-.15623E+00 0.10592E+02 beta (00000124)=0.133819590475111E+02 gamma(00000124)=0.133819590475111E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 124 z1= 1 -.105063040023175E-01 0.000000000000000E+00 z1= 2 -.911038637253694E-06 0.000000000000000E+00 z1= 3 -.145399384780137E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000124)=0.000000000000000E+00 (calc=0.126842069771290E+02 read=0.126842069771290E+02) Weight for this step=-.97432E-01 0.12053E+02 beta (00000125)=0.126842069771290E+02 gamma(00000125)=0.126842069771290E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 125 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000125)=0.000000000000000E+00 (calc=0.133805656187695E+02 read=0.133805656187695E+02) Weight for this step=0.15885E+00 -.10553E+02 beta (00000126)=0.133805656187695E+02 gamma(00000126)=0.133805656187695E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 126 z1= 1 0.100407198121749E-01 0.000000000000000E+00 z1= 2 0.935575094093959E-06 0.000000000000000E+00 z1= 3 0.130505171088650E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000126)=0.000000000000000E+00 (calc=0.128061217983270E+02 read=0.128061217983270E+02) Weight for this step=0.10092E+00 -.11942E+02 beta (00000127)=0.128061217983270E+02 gamma(00000127)=0.128061217983270E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 127 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000127)=0.000000000000000E+00 (calc=0.132907873463496E+02 read=0.132907873463496E+02) Weight for this step=-.15989E+00 0.10416E+02 beta (00000128)=0.132907873463496E+02 gamma(00000128)=0.132907873463496E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 128 z1= 1 -.973654736399135E-02 0.000000000000000E+00 z1= 2 -.975651045347255E-06 0.000000000000000E+00 z1= 3 -.109019815336284E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000128)=0.000000000000000E+00 (calc=0.127747979824044E+02 read=0.127747979824044E+02) Weight for this step=-.10590E+00 0.12020E+02 beta (00000129)=0.127747979824044E+02 gamma(00000129)=0.127747979824044E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 129 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000129)=0.000000000000000E+00 (calc=0.132951221093815E+02 read=0.132951221093815E+02) Weight for this step=0.15998E+00 -.10221E+02 beta (00000130)=0.132951221093815E+02 gamma(00000130)=0.132951221093815E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 130 z1= 1 0.941458437386726E-02 0.000000000000000E+00 z1= 2 0.100437098483723E-05 0.000000000000000E+00 z1= 3 0.921019464286059E-07 0.000000000000000E+00 Calculating total response charge density alpha(00000130)=0.000000000000000E+00 (calc=0.127446368980114E+02 read=0.127446368980114E+02) Weight for this step=0.11040E+00 -.12053E+02 beta (00000131)=0.127446368980114E+02 gamma(00000131)=0.127446368980114E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 131 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000131)=0.000000000000000E+00 (calc=0.131433389165322E+02 read=0.131433389165322E+02) Weight for this step=-.16027E+00 0.10043E+02 beta (00000132)=0.131433389165322E+02 gamma(00000132)=0.131433389165322E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 132 z1= 1 -.917800668191584E-02 0.000000000000000E+00 z1= 2 -.103247825174874E-05 0.000000000000000E+00 z1= 3 -.716475946918539E-07 0.000000000000000E+00 Calculating total response charge density alpha(00000132)=0.000000000000000E+00 (calc=0.127576275649699E+02 read=0.127576275649699E+02) Weight for this step=-.11580E+00 0.12187E+02 beta (00000133)=0.127576275649699E+02 gamma(00000133)=0.127576275649699E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 133 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000133)=0.000000000000000E+00 (calc=0.134670373804933E+02 read=0.134670373804933E+02) Weight for this step=0.15822E+00 -.97215E+01 beta (00000134)=0.134670373804933E+02 gamma(00000134)=0.134670373804933E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 134 z1= 1 0.869346845310137E-02 0.000000000000000E+00 z1= 2 0.102849041815935E-05 0.000000000000000E+00 z1= 3 0.501359931347504E-07 0.000000000000000E+00 Calculating total response charge density alpha(00000134)=0.000000000000000E+00 (calc=0.127762111987481E+02 read=0.127762111987481E+02) Weight for this step=0.11811E+00 -.12018E+02 beta (00000135)=0.127762111987481E+02 gamma(00000135)=0.127762111987481E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 135 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000135)=0.000000000000000E+00 (calc=0.134260196816553E+02 read=0.134260196816553E+02) Weight for this step=-.15978E+00 0.96314E+01 beta (00000136)=0.134260196816553E+02 gamma(00000136)=0.134260196816553E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 136 z1= 1 -.830308344190589E-02 0.000000000000000E+00 z1= 2 -.102584942082967E-05 0.000000000000000E+00 z1= 3 -.283153749147756E-07 0.000000000000000E+00 Calculating total response charge density alpha(00000136)=0.000000000000000E+00 (calc=0.129114181695599E+02 read=0.129114181695599E+02) Weight for this step=-.12090E+00 0.11906E+02 beta (00000137)=0.129114181695599E+02 gamma(00000137)=0.129114181695599E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 137 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000137)=0.000000000000000E+00 (calc=0.133836378132805E+02 read=0.133836378132805E+02) Weight for this step=0.15910E+00 -.94117E+01 beta (00000138)=0.133836378132805E+02 gamma(00000138)=0.133836378132805E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 138 z1= 1 0.809066839462529E-02 0.000000000000000E+00 z1= 2 0.103366758851236E-05 0.000000000000000E+00 z1= 3 0.214075210767310E-08 0.000000000000000E+00 Calculating total response charge density alpha(00000138)=0.000000000000000E+00 (calc=0.129445301041632E+02 read=0.129445301041632E+02) Weight for this step=0.12512E+00 -.11946E+02 beta (00000139)=0.129445301041632E+02 gamma(00000139)=0.129445301041632E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 139 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000139)=0.000000000000000E+00 (calc=0.135470945933053E+02 read=0.135470945933053E+02) Weight for this step=-.15724E+00 0.91268E+01 beta (00000140)=0.135470945933053E+02 gamma(00000140)=0.135470945933053E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 140 z1= 1 -.782221861698094E-02 0.000000000000000E+00 z1= 2 -.103780122764560E-05 0.000000000000000E+00 z1= 3 0.153757342759601E-07 0.000000000000000E+00 Calculating total response charge density alpha(00000140)=0.000000000000000E+00 (calc=0.127278500681737E+02 read=0.127278500681737E+02) Weight for this step=-.12783E+00 0.11856E+02 beta (00000141)=0.127278500681737E+02 gamma(00000141)=0.127278500681737E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 141 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000141)=0.000000000000000E+00 (calc=0.134909225403750E+02 read=0.134909225403750E+02) Weight for this step=0.15986E+00 -.91046E+01 beta (00000142)=0.134909225403750E+02 gamma(00000142)=0.134909225403750E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 142 z1= 1 0.747257450415641E-02 0.000000000000000E+00 z1= 2 0.103219084342894E-05 0.000000000000000E+00 z1= 3 -.426115503923685E-07 0.000000000000000E+00 Calculating total response charge density alpha(00000142)=0.000000000000000E+00 (calc=0.127388156043148E+02 read=0.127388156043148E+02) Weight for this step=0.12903E+00 -.11627E+02 beta (00000143)=0.127388156043148E+02 gamma(00000143)=0.127388156043148E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 143 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000143)=0.000000000000000E+00 (calc=0.134409861488023E+02 read=0.134409861488023E+02) Weight for this step=-.16175E+00 0.90446E+01 beta (00000144)=0.134409861488023E+02 gamma(00000144)=0.134409861488023E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 144 z1= 1 -.714987006675110E-02 0.000000000000000E+00 z1= 2 -.103565575159965E-05 0.000000000000000E+00 z1= 3 0.747142200744396E-07 0.000000000000000E+00 Calculating total response charge density alpha(00000144)=0.000000000000000E+00 (calc=0.129263380082070E+02 read=0.129263380082070E+02) Weight for this step=-.13084E+00 0.11460E+02 beta (00000145)=0.129263380082070E+02 gamma(00000145)=0.129263380082070E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 145 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000145)=0.000000000000000E+00 (calc=0.133955227296483E+02 read=0.133955227296483E+02) Weight for this step=0.16068E+00 -.88244E+01 beta (00000146)=0.133955227296483E+02 gamma(00000146)=0.133955227296483E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 146 z1= 1 0.694930825541806E-02 0.000000000000000E+00 z1= 2 0.105951586620119E-05 0.000000000000000E+00 z1= 3 -.106382370202709E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000146)=0.000000000000000E+00 (calc=0.128294771867733E+02 read=0.128294771867733E+02) Weight for this step=0.13477E+00 -.11490E+02 beta (00000147)=0.128294771867733E+02 gamma(00000147)=0.128294771867733E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 147 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000147)=0.000000000000000E+00 (calc=0.136375187426128E+02 read=0.136375187426128E+02) Weight for this step=-.16000E+00 0.86275E+01 beta (00000148)=0.136375187426128E+02 gamma(00000148)=0.136375187426128E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 148 z1= 1 -.656968419148941E-02 0.000000000000000E+00 z1= 2 -.105905023126737E-05 0.000000000000000E+00 z1= 3 0.143453457142687E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000148)=0.000000000000000E+00 (calc=0.127203052168230E+02 read=0.127203052168230E+02) Weight for this step=-.13509E+00 0.11223E+02 beta (00000149)=0.127203052168230E+02 gamma(00000149)=0.127203052168230E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 149 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000149)=0.000000000000000E+00 (calc=0.135407487783685E+02 read=0.135407487783685E+02) Weight for this step=0.16370E+00 -.86721E+01 beta (00000150)=0.135407487783685E+02 gamma(00000150)=0.135407487783685E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 150 z1= 1 0.618142103555483E-02 0.000000000000000E+00 z1= 2 0.106239929381548E-05 0.000000000000000E+00 z1= 3 -.176432842718000E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000150)=0.000000000000000E+00 (calc=0.126679065104762E+02 read=0.126679065104762E+02) Weight for this step=0.13546E+00 -.10962E+02 beta (00000151)=0.126679065104762E+02 gamma(00000151)=0.126679065104762E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 151 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000151)=0.000000000000000E+00 (calc=0.134957587978244E+02 read=0.134957587978244E+02) Weight for this step=-.16712E+00 0.87032E+01 beta (00000152)=0.134957587978244E+02 gamma(00000152)=0.134957587978244E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 152 z1= 1 -.579872160442296E-02 0.000000000000000E+00 z1= 2 -.105917501270472E-05 0.000000000000000E+00 z1= 3 0.207604477457245E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000152)=0.000000000000000E+00 (calc=0.125471928444096E+02 read=0.125471928444096E+02) Weight for this step=-.13590E+00 0.10712E+02 beta (00000153)=0.125471928444096E+02 gamma(00000153)=0.125471928444096E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 153 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000153)=0.000000000000000E+00 (calc=0.132884914183278E+02 read=0.132884914183278E+02) Weight for this step=0.17181E+00 -.88023E+01 beta (00000154)=0.132884914183278E+02 gamma(00000154)=0.132884914183278E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 154 z1= 1 0.545208339904904E-02 0.000000000000000E+00 z1= 2 0.105819184725723E-05 0.000000000000000E+00 z1= 3 -.241470418045934E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000154)=0.000000000000000E+00 (calc=0.128413090273545E+02 read=0.128413090273545E+02) Weight for this step=0.13745E+00 -.10548E+02 beta (00000155)=0.128413090273545E+02 gamma(00000155)=0.128413090273545E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 155 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000155)=0.000000000000000E+00 (calc=0.133879531090786E+02 read=0.133879531090786E+02) Weight for this step=-.16996E+00 0.85711E+01 beta (00000156)=0.133879531090786E+02 gamma(00000156)=0.133879531090786E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 156 z1= 1 -.518970398994723E-02 0.000000000000000E+00 z1= 2 -.107590853699359E-05 0.000000000000000E+00 z1= 3 0.269791300672021E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000156)=0.000000000000000E+00 (calc=0.128086763473672E+02 read=0.128086763473672E+02) Weight for this step=-.14079E+00 0.10536E+02 beta (00000157)=0.128086763473672E+02 gamma(00000157)=0.128086763473672E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 157 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000157)=0.000000000000000E+00 (calc=0.135343392043371E+02 read=0.135343392043371E+02) Weight for this step=0.16963E+00 -.84203E+01 beta (00000158)=0.135343392043371E+02 gamma(00000158)=0.135343392043371E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 158 z1= 1 0.482101765308390E-02 0.000000000000000E+00 z1= 2 0.107946488651163E-05 0.000000000000000E+00 z1= 3 -.298248007092757E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000158)=0.000000000000000E+00 (calc=0.127047571216248E+02 read=0.127047571216248E+02) Weight for this step=0.14206E+00 -.10379E+02 beta (00000159)=0.127047571216248E+02 gamma(00000159)=0.127047571216248E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 159 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000159)=0.000000000000000E+00 (calc=0.132659520731535E+02 read=0.132659520731535E+02) Weight for this step=-.17257E+00 0.84354E+01 beta (00000160)=0.132659520731535E+02 gamma(00000160)=0.132659520731535E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 160 z1= 1 -.451833137400098E-02 0.000000000000000E+00 z1= 2 -.108928754226963E-05 0.000000000000000E+00 z1= 3 0.326014265772411E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000160)=0.000000000000000E+00 (calc=0.125635444847843E+02 read=0.125635444847843E+02) Weight for this step=-.14521E+00 0.10356E+02 beta (00000161)=0.125635444847843E+02 gamma(00000161)=0.125635444847843E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 161 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000161)=0.000000000000000E+00 (calc=0.133039650048178E+02 read=0.133039650048178E+02) Weight for this step=0.17383E+00 -.83674E+01 beta (00000162)=0.133039650048178E+02 gamma(00000162)=0.133039650048178E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 162 z1= 1 0.422989393475103E-02 0.000000000000000E+00 z1= 2 0.107237096824784E-05 0.000000000000000E+00 z1= 3 -.341090419795948E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000162)=0.000000000000000E+00 (calc=0.127494976945611E+02 read=0.127494976945611E+02) Weight for this step=0.14631E+00 -.10191E+02 beta (00000163)=0.127494976945611E+02 gamma(00000163)=0.127494976945611E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 163 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000163)=0.000000000000000E+00 (calc=0.131751220732392E+02 read=0.131751220732392E+02) Weight for this step=-.17308E+00 0.82081E+01 beta (00000164)=0.131751220732392E+02 gamma(00000164)=0.131751220732392E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 164 z1= 1 -.411021181557778E-02 0.000000000000000E+00 z1= 2 -.107932415821434E-05 0.000000000000000E+00 z1= 3 0.358723656630386E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000164)=0.000000000000000E+00 (calc=0.126038858528184E+02 read=0.126038858528184E+02) Weight for this step=-.15080E+00 0.10270E+02 beta (00000165)=0.126038858528184E+02 gamma(00000165)=0.126038858528184E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 165 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000165)=0.000000000000000E+00 (calc=0.134358651607230E+02 read=0.134358651607230E+02) Weight for this step=0.17227E+00 -.80467E+01 beta (00000166)=0.134358651607230E+02 gamma(00000166)=0.134358651607230E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 166 z1= 1 0.389743633616330E-02 0.000000000000000E+00 z1= 2 0.106351651334526E-05 0.000000000000000E+00 z1= 3 -.363840099681196E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000166)=0.000000000000000E+00 (calc=0.127184531182956E+02 read=0.127184531182956E+02) Weight for this step=0.15046E+00 -.10026E+02 beta (00000167)=0.127184531182956E+02 gamma(00000167)=0.127184531182956E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 167 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000167)=0.000000000000000E+00 (calc=0.134466491370528E+02 read=0.134466491370528E+02) Weight for this step=-.17346E+00 0.79846E+01 beta (00000168)=0.134466491370528E+02 gamma(00000168)=0.134466491370528E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 168 z1= 1 -.379394926791080E-02 0.000000000000000E+00 z1= 2 -.106860606759532E-05 0.000000000000000E+00 z1= 3 0.375198667663533E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000168)=0.000000000000000E+00 (calc=0.127723830797894E+02 read=0.127723830797894E+02) Weight for this step=-.15135E+00 0.98716E+01 beta (00000169)=0.127723830797894E+02 gamma(00000169)=0.127723830797894E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 169 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000169)=0.000000000000000E+00 (calc=0.132923299457340E+02 read=0.132923299457340E+02) Weight for this step=0.17409E+00 -.79002E+01 beta (00000170)=0.132923299457340E+02 gamma(00000170)=0.132923299457340E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 170 z1= 1 0.375431419177870E-02 0.000000000000000E+00 z1= 2 0.108192136032614E-05 0.000000000000000E+00 z1= 3 -.391418672889303E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000170)=0.000000000000000E+00 (calc=0.127568537653709E+02 read=0.127568537653709E+02) Weight for this step=0.15459E+00 -.98745E+01 beta (00000171)=0.127568537653709E+02 gamma(00000171)=0.127568537653709E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 171 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000171)=0.000000000000000E+00 (calc=0.133681844730715E+02 read=0.133681844730715E+02) Weight for this step=-.17269E+00 0.77252E+01 beta (00000172)=0.133681844730715E+02 gamma(00000172)=0.133681844730715E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 172 z1= 1 -.371251517757455E-02 0.000000000000000E+00 z1= 2 -.108819798577816E-05 0.000000000000000E+00 z1= 3 0.411347411132380E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000172)=0.000000000000000E+00 (calc=0.127960390998196E+02 read=0.127960390998196E+02) Weight for this step=-.15656E+00 0.98012E+01 beta (00000173)=0.127960390998196E+02 gamma(00000173)=0.127960390998196E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 173 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000173)=0.000000000000000E+00 (calc=0.134741880298252E+02 read=0.134741880298252E+02) Weight for this step=0.17163E+00 -.75692E+01 beta (00000174)=0.134741880298252E+02 gamma(00000174)=0.134741880298252E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 174 z1= 1 0.357091419553455E-02 0.000000000000000E+00 z1= 2 0.109239864556866E-05 0.000000000000000E+00 z1= 3 -.421277122127886E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000174)=0.000000000000000E+00 (calc=0.128361165145557E+02 read=0.128361165145557E+02) Weight for this step=0.15758E+00 -.96756E+01 beta (00000175)=0.128361165145557E+02 gamma(00000175)=0.128361165145557E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 175 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000175)=0.000000000000000E+00 (calc=0.133955756800338E+02 read=0.133955756800338E+02) Weight for this step=-.17138E+00 0.74520E+01 beta (00000176)=0.133955756800338E+02 gamma(00000176)=0.133955756800338E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 176 z1= 1 -.335490482848328E-02 0.000000000000000E+00 z1= 2 -.110311873687419E-05 0.000000000000000E+00 z1= 3 0.437563654393229E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000176)=0.000000000000000E+00 (calc=0.127371839828646E+02 read=0.127371839828646E+02) Weight for this step=-.15993E+00 0.96357E+01 beta (00000177)=0.127371839828646E+02 gamma(00000177)=0.127371839828646E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 177 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000177)=0.000000000000000E+00 (calc=0.133609363693625E+02 read=0.133609363693625E+02) Weight for this step=0.17126E+00 -.73420E+01 beta (00000178)=0.133609363693625E+02 gamma(00000178)=0.133609363693625E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 178 z1= 1 0.312197134721187E-02 0.000000000000000E+00 z1= 2 0.111885663447043E-05 0.000000000000000E+00 z1= 3 -.455377773094499E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000178)=0.000000000000000E+00 (calc=0.126228630753695E+02 read=0.126228630753695E+02) Weight for this step=0.16140E+00 -.95455E+01 beta (00000179)=0.126228630753695E+02 gamma(00000179)=0.126228630753695E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 179 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000179)=0.000000000000000E+00 (calc=0.134189381208145E+02 read=0.134189381208145E+02) Weight for this step=-.17215E+00 0.72763E+01 beta (00000180)=0.134189381208145E+02 gamma(00000180)=0.134189381208145E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 180 z1= 1 -.280502188068698E-02 0.000000000000000E+00 z1= 2 -.111731527885871E-05 0.000000000000000E+00 z1= 3 0.470827569548724E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000180)=0.000000000000000E+00 (calc=0.127642282345104E+02 read=0.127642282345104E+02) Weight for this step=-.16077E+00 0.93342E+01 beta (00000181)=0.127642282345104E+02 gamma(00000181)=0.127642282345104E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 181 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000181)=0.000000000000000E+00 (calc=0.134409127238685E+02 read=0.134409127238685E+02) Weight for this step=0.17200E+00 -.71709E+01 beta (00000182)=0.134409127238685E+02 gamma(00000182)=0.134409127238685E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 182 z1= 1 0.252767765172751E-02 0.000000000000000E+00 z1= 2 0.112233211982003E-05 0.000000000000000E+00 z1= 3 -.495709351968591E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000182)=0.000000000000000E+00 (calc=0.128179004212276E+02 read=0.128179004212276E+02) Weight for this step=0.16158E+00 -.92135E+01 beta (00000183)=0.128179004212276E+02 gamma(00000183)=0.128179004212276E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 183 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000183)=0.000000000000000E+00 (calc=0.135090365151892E+02 read=0.135090365151892E+02) Weight for this step=-.17139E+00 0.70489E+01 beta (00000184)=0.135090365151892E+02 gamma(00000184)=0.135090365151892E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 184 z1= 1 -.229155380707699E-02 0.000000000000000E+00 z1= 2 -.111688186402777E-05 0.000000000000000E+00 z1= 3 0.506289451474397E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000184)=0.000000000000000E+00 (calc=0.129152290750697E+02 read=0.129152290750697E+02) Weight for this step=-.16214E+00 0.90837E+01 beta (00000185)=0.129152290750697E+02 gamma(00000185)=0.129152290750697E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 185 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000185)=0.000000000000000E+00 (calc=0.133109436733325E+02 read=0.133109436733325E+02) Weight for this step=0.17035E+00 -.69126E+01 beta (00000186)=0.133109436733325E+02 gamma(00000186)=0.133109436733325E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 186 z1= 1 0.208356679327469E-02 0.000000000000000E+00 z1= 2 0.113063285546791E-05 0.000000000000000E+00 z1= 3 -.524520215690712E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000186)=0.000000000000000E+00 (calc=0.127266818667874E+02 read=0.127266818667874E+02) Weight for this step=0.16622E+00 -.91536E+01 beta (00000187)=0.127266818667874E+02 gamma(00000187)=0.127266818667874E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 187 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000187)=0.000000000000000E+00 (calc=0.134537848794894E+02 read=0.134537848794894E+02) Weight for this step=-.16890E+00 0.67592E+01 beta (00000188)=0.134537848794894E+02 gamma(00000188)=0.134537848794894E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 188 z1= 1 -.185792183623537E-02 0.000000000000000E+00 z1= 2 -.110250647209474E-05 0.000000000000000E+00 z1= 3 0.531931530495304E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000188)=0.000000000000000E+00 (calc=0.129513195527258E+02 read=0.129513195527258E+02) Weight for this step=-.16596E+00 0.89877E+01 beta (00000189)=0.129513195527258E+02 gamma(00000189)=0.129513195527258E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 189 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000189)=0.000000000000000E+00 (calc=0.137067215286686E+02 read=0.137067215286686E+02) Weight for this step=0.16637E+00 -.65671E+01 beta (00000190)=0.137067215286686E+02 gamma(00000190)=0.137067215286686E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 190 z1= 1 0.163467287576130E-02 0.000000000000000E+00 z1= 2 0.107499524158120E-05 0.000000000000000E+00 z1= 3 -.531449173196154E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000190)=0.000000000000000E+00 (calc=0.128651968884116E+02 read=0.128651968884116E+02) Weight for this step=0.16524E+00 -.88060E+01 beta (00000191)=0.128651968884116E+02 gamma(00000191)=0.128651968884116E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 191 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000191)=0.000000000000000E+00 (calc=0.134373766820750E+02 read=0.134373766820750E+02) Weight for this step=-.16816E+00 0.65487E+01 beta (00000192)=0.134373766820750E+02 gamma(00000192)=0.134373766820750E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 192 z1= 1 -.143882185332284E-02 0.000000000000000E+00 z1= 2 -.105886850888456E-05 0.000000000000000E+00 z1= 3 0.542010971587350E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000192)=0.000000000000000E+00 (calc=0.127839119588456E+02 read=0.127839119588456E+02) Weight for this step=-.16688E+00 0.87500E+01 beta (00000193)=0.127839119588456E+02 gamma(00000193)=0.127839119588456E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 193 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000193)=0.000000000000000E+00 (calc=0.131981251531839E+02 read=0.131981251531839E+02) Weight for this step=0.16753E+00 -.64354E+01 beta (00000194)=0.131981251531839E+02 gamma(00000194)=0.131981251531839E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 194 z1= 1 0.131545235360777E-02 0.000000000000000E+00 z1= 2 0.105305416555094E-05 0.000000000000000E+00 z1= 3 -.554355806928729E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000194)=0.000000000000000E+00 (calc=0.126839745775896E+02 read=0.126839745775896E+02) Weight for this step=0.17044E+00 -.87946E+01 beta (00000195)=0.126839745775896E+02 gamma(00000195)=0.126839745775896E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 195 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000195)=0.000000000000000E+00 (calc=0.133139834830163E+02 read=0.133139834830163E+02) Weight for this step=-.16483E+00 0.62424E+01 beta (00000196)=0.133139834830163E+02 gamma(00000196)=0.133139834830163E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 196 z1= 1 -.121591283901509E-02 0.000000000000000E+00 z1= 2 -.102930249793560E-05 0.000000000000000E+00 z1= 3 0.558466701815544E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000196)=0.000000000000000E+00 (calc=0.126079509475032E+02 read=0.126079509475032E+02) Weight for this step=-.17095E+00 0.86853E+01 beta (00000197)=0.126079509475032E+02 gamma(00000197)=0.126079509475032E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 197 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000197)=0.000000000000000E+00 (calc=0.136343158091605E+02 read=0.136343158091605E+02) Weight for this step=0.16450E+00 -.61410E+01 beta (00000198)=0.136343158091605E+02 gamma(00000198)=0.136343158091605E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 198 z1= 1 0.114353515645789E-02 0.000000000000000E+00 z1= 2 0.981641408036435E-06 0.000000000000000E+00 z1= 3 -.543802321765596E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000198)=0.000000000000000E+00 (calc=0.126706191309363E+02 read=0.126706191309363E+02) Weight for this step=0.16643E+00 -.83263E+01 beta (00000199)=0.126706191309363E+02 gamma(00000199)=0.126706191309363E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 199 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000199)=0.000000000000000E+00 (calc=0.134978593621574E+02 read=0.134978593621574E+02) Weight for this step=-.16775E+00 0.61779E+01 beta (00000200)=0.134978593621574E+02 gamma(00000200)=0.134978593621574E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 200 z1= 1 -.113911411985839E-02 0.000000000000000E+00 z1= 2 -.955346051703264E-06 0.000000000000000E+00 z1= 3 0.546105423315075E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000200)=0.000000000000000E+00 (calc=0.126143078226329E+02 read=0.126143078226329E+02) Weight for this step=-.16482E+00 0.81156E+01 beta (00000201)=0.126143078226329E+02 gamma(00000201)=0.126143078226329E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 201 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000201)=0.000000000000000E+00 (calc=0.133826748513058E+02 read=0.133826748513058E+02) Weight for this step=0.17030E+00 -.61895E+01 beta (00000202)=0.133826748513058E+02 gamma(00000202)=0.133826748513058E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 202 z1= 1 0.113984829697640E-02 0.000000000000000E+00 z1= 2 0.927114220534899E-06 0.000000000000000E+00 z1= 3 -.550789200271364E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000202)=0.000000000000000E+00 (calc=0.127737791908955E+02 read=0.127737791908955E+02) Weight for this step=0.16415E+00 -.79524E+01 beta (00000203)=0.127737791908955E+02 gamma(00000203)=0.127737791908955E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 203 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000203)=0.000000000000000E+00 (calc=0.135575564890144E+02 read=0.135575564890144E+02) Weight for this step=-.16939E+00 0.60770E+01 beta (00000204)=0.135575564890144E+02 gamma(00000204)=0.135575564890144E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 204 z1= 1 -.112061632640548E-02 0.000000000000000E+00 z1= 2 -.896360847984536E-06 0.000000000000000E+00 z1= 3 0.552426030503265E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000204)=0.000000000000000E+00 (calc=0.128450514362886E+02 read=0.128450514362886E+02) Weight for this step=-.16329E+00 0.77861E+01 beta (00000205)=0.128450514362886E+02 gamma(00000205)=0.128450514362886E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 205 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000205)=0.000000000000000E+00 (calc=0.134791529765032E+02 read=0.134791529765032E+02) Weight for this step=0.16986E+00 -.60173E+01 beta (00000206)=0.134791529765032E+02 gamma(00000206)=0.134791529765032E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 206 z1= 1 0.117517379904983E-02 0.000000000000000E+00 z1= 2 0.883319222565182E-06 0.000000000000000E+00 z1= 3 -.563918251377741E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000206)=0.000000000000000E+00 (calc=0.127620257968271E+02 read=0.127620257968271E+02) Weight for this step=0.16430E+00 -.77120E+01 beta (00000207)=0.127620257968271E+02 gamma(00000207)=0.127620257968271E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 207 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000207)=0.000000000000000E+00 (calc=0.133839143377821E+02 read=0.133839143377821E+02) Weight for this step=-.17037E+00 0.59599E+01 beta (00000208)=0.133839143377821E+02 gamma(00000208)=0.133839143377821E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 208 z1= 1 -.125141545621655E-02 0.000000000000000E+00 z1= 2 -.878531473391501E-06 0.000000000000000E+00 z1= 3 0.574961863397834E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000208)=0.000000000000000E+00 (calc=0.126288027754579E+02 read=0.126288027754579E+02) Weight for this step=-.16544E+00 0.76452E+01 beta (00000209)=0.126288027754579E+02 gamma(00000209)=0.126288027754579E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 209 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000209)=0.000000000000000E+00 (calc=0.135242431178511E+02 read=0.135242431178511E+02) Weight for this step=0.17138E+00 -.59200E+01 beta (00000210)=0.135242431178511E+02 gamma(00000210)=0.135242431178511E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 210 z1= 1 0.133343583494327E-02 0.000000000000000E+00 z1= 2 0.873678503602454E-06 0.000000000000000E+00 z1= 3 -.570953538855706E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000210)=0.000000000000000E+00 (calc=0.126503383251568E+02 read=0.126503383251568E+02) Weight for this step=0.16322E+00 -.74255E+01 beta (00000211)=0.126503383251568E+02 gamma(00000211)=0.126503383251568E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 211 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000211)=0.000000000000000E+00 (calc=0.135864455717396E+02 read=0.135864455717396E+02) Weight for this step=-.17418E+00 0.59447E+01 beta (00000212)=0.135864455717396E+02 gamma(00000212)=0.135864455717396E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 212 z1= 1 -.134116145421016E-02 0.000000000000000E+00 z1= 2 -.865496757003655E-06 0.000000000000000E+00 z1= 3 0.565657256031398E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000212)=0.000000000000000E+00 (calc=0.126859780805401E+02 read=0.126859780805401E+02) Weight for this step=-.16081E+00 0.72003E+01 beta (00000213)=0.126859780805401E+02 gamma(00000213)=0.126859780805401E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 213 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000213)=0.000000000000000E+00 (calc=0.134727118487149E+02 read=0.134727118487149E+02) Weight for this step=0.17768E+00 -.59952E+01 beta (00000214)=0.134727118487149E+02 gamma(00000214)=0.134727118487149E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 214 z1= 1 0.124204621259663E-02 0.000000000000000E+00 z1= 2 0.850026841560381E-06 0.000000000000000E+00 z1= 3 -.570084573563352E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000214)=0.000000000000000E+00 (calc=0.125567710475452E+02 read=0.125567710475452E+02) Weight for this step=0.16049E+00 -.70711E+01 beta (00000215)=0.125567710475452E+02 gamma(00000215)=0.125567710475452E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 215 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000215)=0.000000000000000E+00 (calc=0.132488407992983E+02 read=0.132488407992983E+02) Weight for this step=-.18171E+00 0.60639E+01 beta (00000216)=0.132488407992983E+02 gamma(00000216)=0.132488407992983E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 216 z1= 1 -.111926534567439E-02 0.000000000000000E+00 z1= 2 -.851692033702542E-06 0.000000000000000E+00 z1= 3 0.573702861172498E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000216)=0.000000000000000E+00 (calc=0.124624285870993E+02 read=0.124624285870993E+02) Weight for this step=-.16155E+00 0.70013E+01 beta (00000217)=0.124624285870993E+02 gamma(00000217)=0.124624285870993E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 217 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000217)=0.000000000000000E+00 (calc=0.136513087249418E+02 read=0.136513087249418E+02) Weight for this step=0.18413E+00 -.60788E+01 beta (00000218)=0.136513087249418E+02 gamma(00000218)=0.136513087249418E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 218 z1= 1 0.927133309596425E-03 0.000000000000000E+00 z1= 2 0.828441397940360E-06 0.000000000000000E+00 z1= 3 -.552086111015688E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000218)=0.000000000000000E+00 (calc=0.127274171756467E+02 read=0.127274171756467E+02) Weight for this step=0.15675E+00 -.66831E+01 beta (00000219)=0.127274171756467E+02 gamma(00000219)=0.127274171756467E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 219 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000219)=0.000000000000000E+00 (calc=0.134287316112827E+02 read=0.134287316112827E+02) Weight for this step=-.18891E+00 0.61763E+01 beta (00000220)=0.134287316112827E+02 gamma(00000220)=0.134287316112827E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 220 z1= 1 -.776937897958834E-03 0.000000000000000E+00 z1= 2 -.850435106803174E-06 0.000000000000000E+00 z1= 3 0.552314499213473E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000220)=0.000000000000000E+00 (calc=0.127703385230753E+02 read=0.127703385230753E+02) Weight for this step=-.15823E+00 0.66351E+01 beta (00000221)=0.127703385230753E+02 gamma(00000221)=0.127703385230753E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 221 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000221)=0.000000000000000E+00 (calc=0.132933852392960E+02 read=0.132933852392960E+02) Weight for this step=0.19002E+00 -.61547E+01 beta (00000222)=0.132933852392960E+02 gamma(00000222)=0.132933852392960E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 222 z1= 1 0.620793139703533E-03 0.000000000000000E+00 z1= 2 0.872603414170045E-06 0.000000000000000E+00 z1= 3 -.564776487906190E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000222)=0.000000000000000E+00 (calc=0.128282662010717E+02 read=0.128282662010717E+02) Weight for this step=0.16183E+00 -.66771E+01 beta (00000223)=0.128282662010717E+02 gamma(00000223)=0.128282662010717E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 223 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000223)=0.000000000000000E+00 (calc=0.132058851683286E+02 read=0.132058851683286E+02) Weight for this step=-.18813E+00 0.60371E+01 beta (00000224)=0.132058851683286E+02 gamma(00000224)=0.132058851683286E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 224 z1= 1 -.430502528952067E-03 0.000000000000000E+00 z1= 2 -.910033572316601E-06 0.000000000000000E+00 z1= 3 0.581363414216295E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000224)=0.000000000000000E+00 (calc=0.129770284465301E+02 read=0.129770284465301E+02) Weight for this step=-.16698E+00 0.67854E+01 beta (00000225)=0.129770284465301E+02 gamma(00000225)=0.129770284465301E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 225 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000225)=0.000000000000000E+00 (calc=0.133541678455374E+02 read=0.133541678455374E+02) Weight for this step=0.18250E+00 -.58013E+01 beta (00000226)=0.133541678455374E+02 gamma(00000226)=0.133541678455374E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 226 z1= 1 0.236359807282170E-03 0.000000000000000E+00 z1= 2 0.944396300966988E-06 0.000000000000000E+00 z1= 3 -.599137290043590E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000226)=0.000000000000000E+00 (calc=0.128225177301424E+02 read=0.128225177301424E+02) Weight for this step=0.17165E+00 -.68781E+01 beta (00000227)=0.128225177301424E+02 gamma(00000227)=0.128225177301424E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 227 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000227)=0.000000000000000E+00 (calc=0.135109032782034E+02 read=0.135109032782034E+02) Weight for this step=-.18077E+00 0.56907E+01 beta (00000228)=0.135109032782034E+02 gamma(00000228)=0.135109032782034E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 228 z1= 1 -.768143767972554E-04 0.000000000000000E+00 z1= 2 -.953992358885755E-06 0.000000000000000E+00 z1= 3 0.599081158057216E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000228)=0.000000000000000E+00 (calc=0.127024305611170E+02 read=0.127024305611170E+02) Weight for this step=-.17208E+00 0.68034E+01 beta (00000229)=0.127024305611170E+02 gamma(00000229)=0.127024305611170E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 229 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000229)=0.000000000000000E+00 (calc=0.134491685566602E+02 read=0.134491685566602E+02) Weight for this step=0.18287E+00 -.57024E+01 beta (00000230)=0.134491685566602E+02 gamma(00000230)=0.134491685566602E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 230 z1= 1 -.456238715347496E-04 0.000000000000000E+00 z1= 2 0.972373499379120E-06 0.000000000000000E+00 z1= 3 -.599324632430094E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000230)=0.000000000000000E+00 (calc=0.129123583256806E+02 read=0.129123583256806E+02) Weight for this step=0.17185E+00 -.67032E+01 beta (00000231)=0.129123583256806E+02 gamma(00000231)=0.129123583256806E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 231 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000231)=0.000000000000000E+00 (calc=0.137268118423163E+02 read=0.137268118423163E+02) Weight for this step=-.18124E+00 0.55996E+01 beta (00000232)=0.137268118423163E+02 gamma(00000232)=0.137268118423163E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 232 z1= 1 0.113549625719299E-03 0.000000000000000E+00 z1= 2 -.987279831889468E-06 0.000000000000000E+00 z1= 3 0.598239286623620E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000232)=0.000000000000000E+00 (calc=0.127781226981588E+02 read=0.127781226981588E+02) Weight for this step=-.17071E+00 0.65725E+01 beta (00000233)=0.127781226981588E+02 gamma(00000233)=0.127781226981588E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 233 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000233)=0.000000000000000E+00 (calc=0.133503640232404E+02 read=0.133503640232404E+02) Weight for this step=0.18544E+00 -.56787E+01 beta (00000234)=0.133503640232404E+02 gamma(00000234)=0.133503640232404E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 234 z1= 1 -.180167775299335E-03 0.000000000000000E+00 z1= 2 0.100947541557643E-05 0.000000000000000E+00 z1= 3 -.616492567146924E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000234)=0.000000000000000E+00 (calc=0.125912037225209E+02 read=0.125912037225209E+02) Weight for this step=0.17291E+00 -.65692E+01 beta (00000235)=0.125912037225209E+02 gamma(00000235)=0.125912037225209E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 235 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000235)=0.000000000000000E+00 (calc=0.133931145870886E+02 read=0.133931145870886E+02) Weight for this step=-.18711E+00 0.56795E+01 beta (00000236)=0.133931145870886E+02 gamma(00000236)=0.133931145870886E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 236 z1= 1 0.213843106794772E-03 0.000000000000000E+00 z1= 2 -.102198524602661E-05 0.000000000000000E+00 z1= 3 0.618473620253503E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000236)=0.000000000000000E+00 (calc=0.128915709648554E+02 read=0.128915709648554E+02) Weight for this step=-.17212E+00 0.64534E+01 beta (00000237)=0.128915709648554E+02 gamma(00000237)=0.128915709648554E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 237 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000237)=0.000000000000000E+00 (calc=0.135197347771400E+02 read=0.135197347771400E+02) Weight for this step=0.18515E+00 -.55728E+01 beta (00000238)=0.135197347771400E+02 gamma(00000238)=0.135197347771400E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 238 z1= 1 -.247563404130971E-03 0.000000000000000E+00 z1= 2 0.104532226517275E-05 0.000000000000000E+00 z1= 3 -.624751022326373E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000238)=0.000000000000000E+00 (calc=0.127636417953653E+02 read=0.127636417953653E+02) Weight for this step=0.17350E+00 -.64234E+01 beta (00000239)=0.127636417953653E+02 gamma(00000239)=0.127636417953653E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 239 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000239)=0.000000000000000E+00 (calc=0.133597456736146E+02 read=0.133597456736146E+02) Weight for this step=-.18671E+00 0.55735E+01 beta (00000240)=0.133597456736146E+02 gamma(00000240)=0.133597456736146E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 240 z1= 1 0.255364305983827E-03 0.000000000000000E+00 z1= 2 -.108161162759362E-05 0.000000000000000E+00 z1= 3 0.638990187844658E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000240)=0.000000000000000E+00 (calc=0.127491189689346E+02 read=0.127491189689346E+02) Weight for this step=-.17533E+00 0.64099E+01 beta (00000241)=0.127491189689346E+02 gamma(00000241)=0.127491189689346E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 241 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000241)=0.000000000000000E+00 (calc=0.134029067770379E+02 read=0.134029067770379E+02) Weight for this step=0.18615E+00 -.55114E+01 beta (00000242)=0.134029067770379E+02 gamma(00000242)=0.134029067770379E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 242 z1= 1 -.217590215512890E-03 0.000000000000000E+00 z1= 2 0.110526645249890E-05 0.000000000000000E+00 z1= 3 -.643587884528100E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000242)=0.000000000000000E+00 (calc=0.128892970215508E+02 read=0.128892970215508E+02) Weight for this step=0.17628E+00 -.63664E+01 beta (00000243)=0.128892970215508E+02 gamma(00000243)=0.128892970215508E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 243 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000243)=0.000000000000000E+00 (calc=0.135139908791647E+02 read=0.135139908791647E+02) Weight for this step=-.18412E+00 0.54077E+01 beta (00000244)=0.135139908791647E+02 gamma(00000244)=0.135139908791647E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 244 z1= 1 0.176715163058954E-03 0.000000000000000E+00 z1= 2 -.113487006900368E-05 0.000000000000000E+00 z1= 3 0.646963887364219E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000244)=0.000000000000000E+00 (calc=0.125465565044629E+02 read=0.125465565044629E+02) Weight for this step=-.17745E+00 0.63340E+01 beta (00000245)=0.125465565044629E+02 gamma(00000245)=0.125465565044629E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 245 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000245)=0.000000000000000E+00 (calc=0.130511096565475E+02 read=0.130511096565475E+02) Weight for this step=0.18856E+00 -.54942E+01 beta (00000246)=0.130511096565475E+02 gamma(00000246)=0.130511096565475E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 246 z1= 1 -.687562975012924E-04 0.000000000000000E+00 z1= 2 0.118720817330817E-05 0.000000000000000E+00 z1= 3 -.669074717059813E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000246)=0.000000000000000E+00 (calc=0.125672166216960E+02 read=0.125672166216960E+02) Weight for this step=0.18047E+00 -.63647E+01 beta (00000247)=0.125672166216960E+02 gamma(00000247)=0.125672166216960E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 247 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000247)=0.000000000000000E+00 (calc=0.133322010065832E+02 read=0.133322010065832E+02) Weight for this step=-.18591E+00 0.53742E+01 beta (00000248)=0.133322010065832E+02 gamma(00000248)=0.133322010065832E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 248 z1= 1 -.265855779817228E-04 0.000000000000000E+00 z1= 2 -.121479055689667E-05 0.000000000000000E+00 z1= 3 0.681585116935524E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000248)=0.000000000000000E+00 (calc=0.127880890405297E+02 read=0.127880890405297E+02) Weight for this step=-.17964E+00 0.62633E+01 beta (00000249)=0.127880890405297E+02 gamma(00000249)=0.127880890405297E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 249 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000249)=0.000000000000000E+00 (calc=0.134565553007533E+02 read=0.134565553007533E+02) Weight for this step=0.18414E+00 -.52823E+01 beta (00000250)=0.134565553007533E+02 gamma(00000250)=0.134565553007533E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 250 z1= 1 0.128714655375224E-03 0.000000000000000E+00 z1= 2 0.126106313341583E-05 0.000000000000000E+00 z1= 3 -.694971007484248E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000250)=0.000000000000000E+00 (calc=0.125503578341436E+02 read=0.125503578341436E+02) Weight for this step=0.18007E+00 -.62092E+01 beta (00000251)=0.125503578341436E+02 gamma(00000251)=0.125503578341436E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 251 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000251)=0.000000000000000E+00 (calc=0.132840485165938E+02 read=0.132840485165938E+02) Weight for this step=-.18754E+00 0.53399E+01 beta (00000252)=0.132840485165938E+02 gamma(00000252)=0.132840485165938E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 252 z1= 1 -.179183404497101E-03 0.000000000000000E+00 z1= 2 -.129198898079705E-05 0.000000000000000E+00 z1= 3 0.714225997706409E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000252)=0.000000000000000E+00 (calc=0.129336344933673E+02 read=0.129336344933673E+02) Weight for this step=-.17977E+00 0.61293E+01 beta (00000253)=0.129336344933673E+02 gamma(00000253)=0.129336344933673E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 253 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000253)=0.000000000000000E+00 (calc=0.135149055562963E+02 read=0.135149055562963E+02) Weight for this step=0.18305E+00 -.51743E+01 beta (00000254)=0.135149055562963E+02 gamma(00000254)=0.135149055562963E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 254 z1= 1 0.150891841739855E-03 0.000000000000000E+00 z1= 2 0.133249794851808E-05 0.000000000000000E+00 z1= 3 -.735237230809133E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000254)=0.000000000000000E+00 (calc=0.128019264727368E+02 read=0.128019264727368E+02) Weight for this step=0.18128E+00 -.61163E+01 beta (00000255)=0.128019264727368E+02 gamma(00000255)=0.128019264727368E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 255 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000255)=0.000000000000000E+00 (calc=0.136716635613044E+02 read=0.136716635613044E+02) Weight for this step=-.18350E+00 0.51498E+01 beta (00000256)=0.136716635613044E+02 gamma(00000256)=0.136716635613044E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 256 z1= 1 -.136961296730704E-03 0.000000000000000E+00 z1= 2 -.132756300001962E-05 0.000000000000000E+00 z1= 3 0.740095829824107E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000256)=0.000000000000000E+00 (calc=0.128300167466652E+02 read=0.128300167466652E+02) Weight for this step=-.17891E+00 0.59738E+01 beta (00000257)=0.128300167466652E+02 gamma(00000257)=0.128300167466652E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 257 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000257)=0.000000000000000E+00 (calc=0.134221769871968E+02 read=0.134221769871968E+02) Weight for this step=0.18594E+00 -.51828E+01 beta (00000258)=0.134221769871968E+02 gamma(00000258)=0.134221769871968E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 258 z1= 1 0.138208485808052E-03 0.000000000000000E+00 z1= 2 0.134505375033733E-05 0.000000000000000E+00 z1= 3 -.763117093451342E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000258)=0.000000000000000E+00 (calc=0.130324506658008E+02 read=0.130324506658008E+02) Weight for this step=0.18048E+00 -.59630E+01 beta (00000259)=0.130324506658008E+02 gamma(00000259)=0.130324506658008E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 259 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000259)=0.000000000000000E+00 (calc=0.135340662295567E+02 read=0.135340662295567E+02) Weight for this step=-.18198E+00 0.50383E+01 beta (00000260)=0.135340662295567E+02 gamma(00000260)=0.135340662295567E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 260 z1= 1 -.927788765640526E-04 0.000000000000000E+00 z1= 2 -.136540499718479E-05 0.000000000000000E+00 z1= 3 0.786495671597533E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000260)=0.000000000000000E+00 (calc=0.127717179711288E+02 read=0.127717179711288E+02) Weight for this step=-.18296E+00 0.59857E+01 beta (00000261)=0.127717179711288E+02 gamma(00000261)=0.127717179711288E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 261 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000261)=0.000000000000000E+00 (calc=0.133221305937690E+02 read=0.133221305937690E+02) Weight for this step=0.18300E+00 -.50323E+01 beta (00000262)=0.133221305937690E+02 gamma(00000262)=0.133221305937690E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 262 z1= 1 0.478723208799893E-04 0.000000000000000E+00 z1= 2 0.139451889845724E-05 0.000000000000000E+00 z1= 3 -.808548213449120E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000262)=0.000000000000000E+00 (calc=0.126369438532460E+02 read=0.126369438532460E+02) Weight for this step=0.18477E+00 -.59856E+01 beta (00000263)=0.126369438532460E+02 gamma(00000263)=0.126369438532460E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 263 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000263)=0.000000000000000E+00 (calc=0.132587176270206E+02 read=0.132587176270206E+02) Weight for this step=-.18288E+00 0.49951E+01 beta (00000264)=0.132587176270206E+02 gamma(00000264)=0.132587176270206E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 264 z1= 1 -.455658322307505E-05 0.000000000000000E+00 z1= 2 -.141371746315185E-05 0.000000000000000E+00 z1= 3 0.832726922536550E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000264)=0.000000000000000E+00 (calc=0.127327473213858E+02 read=0.127327473213858E+02) Weight for this step=-.18551E+00 0.59515E+01 beta (00000265)=0.127327473213858E+02 gamma(00000265)=0.127327473213858E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 265 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000265)=0.000000000000000E+00 (calc=0.134480107619529E+02 read=0.134480107619529E+02) Weight for this step=0.18043E+00 -.48955E+01 beta (00000266)=0.134480107619529E+02 gamma(00000266)=0.134480107619529E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 266 z1= 1 0.648813969970907E-05 0.000000000000000E+00 z1= 2 0.143362690442888E-05 0.000000000000000E+00 z1= 3 -.847669821928745E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000266)=0.000000000000000E+00 (calc=0.127991040505564E+02 read=0.127991040505564E+02) Weight for this step=0.18479E+00 -.58732E+01 beta (00000267)=0.127991040505564E+02 gamma(00000267)=0.127991040505564E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 267 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000267)=0.000000000000000E+00 (calc=0.133509673966330E+02 read=0.133509673966330E+02) Weight for this step=-.17966E+00 0.48433E+01 beta (00000268)=0.133509673966330E+02 gamma(00000268)=0.133509673966330E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 268 z1= 1 -.567376802994108E-04 0.000000000000000E+00 z1= 2 -.147476342111756E-05 0.000000000000000E+00 z1= 3 0.861288036506217E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000268)=0.000000000000000E+00 (calc=0.126159925429635E+02 read=0.126159925429635E+02) Weight for this step=-.18632E+00 0.58679E+01 beta (00000269)=0.126159925429635E+02 gamma(00000269)=0.126159925429635E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 269 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000269)=0.000000000000000E+00 (calc=0.135207235004554E+02 read=0.135207235004554E+02) Weight for this step=0.18000E+00 -.48210E+01 beta (00000270)=0.135207235004554E+02 gamma(00000270)=0.135207235004554E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 270 z1= 1 0.127137685652246E-03 0.000000000000000E+00 z1= 2 0.147446017463061E-05 0.000000000000000E+00 z1= 3 -.850926267151298E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000270)=0.000000000000000E+00 (calc=0.130324162067741E+02 read=0.130324162067741E+02) Weight for this step=0.18293E+00 -.57087E+01 beta (00000271)=0.130324162067741E+02 gamma(00000271)=0.130324162067741E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 271 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000271)=0.000000000000000E+00 (calc=0.132956054952244E+02 read=0.132956054952244E+02) Weight for this step=-.17712E+00 0.47149E+01 beta (00000272)=0.132956054952244E+02 gamma(00000272)=0.132956054952244E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 272 z1= 1 -.191729312312948E-03 0.000000000000000E+00 z1= 2 -.155405386660819E-05 0.000000000000000E+00 z1= 3 0.886776127557586E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000272)=0.000000000000000E+00 (calc=0.127269498904768E+02 read=0.127269498904768E+02) Weight for this step=-.18838E+00 0.58278E+01 beta (00000273)=0.127269498904768E+02 gamma(00000273)=0.127269498904768E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 273 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000273)=0.000000000000000E+00 (calc=0.134985209742731E+02 read=0.134985209742731E+02) Weight for this step=0.17488E+00 -.46259E+01 beta (00000274)=0.134985209742731E+02 gamma(00000274)=0.134985209742731E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 274 z1= 1 0.170331338007786E-03 0.000000000000000E+00 z1= 2 0.157806383036148E-05 0.000000000000000E+00 z1= 3 -.880252715059794E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000274)=0.000000000000000E+00 (calc=0.128622188610237E+02 read=0.128622188610237E+02) Weight for this step=0.18644E+00 -.57190E+01 beta (00000275)=0.128622188610237E+02 gamma(00000275)=0.128622188610237E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 275 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000275)=0.000000000000000E+00 (calc=0.137440451936213E+02 read=0.137440451936213E+02) Weight for this step=-.17360E+00 0.45637E+01 beta (00000276)=0.137440451936213E+02 gamma(00000276)=0.137440451936213E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 276 z1= 1 -.142750271903275E-03 0.000000000000000E+00 z1= 2 -.157821809977730E-05 0.000000000000000E+00 z1= 3 0.873149851241851E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000276)=0.000000000000000E+00 (calc=0.127464668374159E+02 read=0.127464668374159E+02) Weight for this step=-.18308E+00 0.55694E+01 beta (00000277)=0.127464668374159E+02 gamma(00000277)=0.127464668374159E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 277 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000277)=0.000000000000000E+00 (calc=0.131863671382823E+02 read=0.131863671382823E+02) Weight for this step=0.17735E+00 -.46348E+01 beta (00000278)=0.131863671382823E+02 gamma(00000278)=0.131863671382823E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 278 z1= 1 0.109572272947518E-03 0.000000000000000E+00 z1= 2 0.163461486807001E-05 0.000000000000000E+00 z1= 3 -.901660216060408E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000278)=0.000000000000000E+00 (calc=0.125348509742997E+02 read=0.125348509742997E+02) Weight for this step=0.18612E+00 -.56137E+01 beta (00000279)=0.125348509742997E+02 gamma(00000279)=0.125348509742997E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 279 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000279)=0.000000000000000E+00 (calc=0.133613119487983E+02 read=0.133613119487983E+02) Weight for this step=-.17640E+00 0.45826E+01 beta (00000280)=0.133613119487983E+02 gamma(00000280)=0.133613119487983E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 280 z1= 1 -.760002265133737E-04 0.000000000000000E+00 z1= 2 -.163669660678198E-05 0.000000000000000E+00 z1= 3 0.896005116320575E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000280)=0.000000000000000E+00 (calc=0.128734593266187E+02 read=0.128734593266187E+02) Weight for this step=-.18360E+00 0.54910E+01 beta (00000281)=0.128734593266187E+02 gamma(00000281)=0.128734593266187E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 281 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000281)=0.000000000000000E+00 (calc=0.132961411401249E+02 read=0.132961411401249E+02) Weight for this step=0.17332E+00 -.44771E+01 beta (00000282)=0.132961411401249E+02 gamma(00000282)=0.132961411401249E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 282 z1= 1 0.276527334064029E-04 0.000000000000000E+00 z1= 2 0.168078713190609E-05 0.000000000000000E+00 z1= 3 -.912525533278022E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000282)=0.000000000000000E+00 (calc=0.125942924204340E+02 read=0.125942924204340E+02) Weight for this step=0.18663E+00 -.55368E+01 beta (00000283)=0.125942924204340E+02 gamma(00000283)=0.125942924204340E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 283 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000283)=0.000000000000000E+00 (calc=0.132143412538638E+02 read=0.132143412538638E+02) Weight for this step=-.17284E+00 0.44388E+01 beta (00000284)=0.132143412538638E+02 gamma(00000284)=0.132143412538638E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 284 z1= 1 0.583239420644463E-04 0.000000000000000E+00 z1= 2 -.169448499549429E-05 0.000000000000000E+00 z1= 3 0.909737797680373E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000284)=0.000000000000000E+00 (calc=0.126628071631529E+02 read=0.126628071631529E+02) Weight for this step=-.18677E+00 0.54969E+01 beta (00000285)=0.126628071631529E+02 gamma(00000285)=0.126628071631529E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 285 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000285)=0.000000000000000E+00 (calc=0.134122172404607E+02 read=0.134122172404607E+02) Weight for this step=0.17028E+00 -.43480E+01 beta (00000286)=0.134122172404607E+02 gamma(00000286)=0.134122172404607E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 286 z1= 1 -.190932279733869E-03 0.000000000000000E+00 z1= 2 0.168270811709472E-05 0.000000000000000E+00 z1= 3 -.905919346849617E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000286)=0.000000000000000E+00 (calc=0.126239998823110E+02 read=0.126239998823110E+02) Weight for this step=0.18497E+00 -.54019E+01 beta (00000287)=0.126239998823110E+02 gamma(00000287)=0.126239998823110E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 287 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000287)=0.000000000000000E+00 (calc=0.130876625119869E+02 read=0.130876625119869E+02) Weight for this step=-.17089E+00 0.43394E+01 beta (00000288)=0.130876625119869E+02 gamma(00000288)=0.130876625119869E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 288 z1= 1 0.349693419300639E-03 0.000000000000000E+00 z1= 2 -.171015172586650E-05 0.000000000000000E+00 z1= 3 0.920518477500582E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000288)=0.000000000000000E+00 (calc=0.127646903035548E+02 read=0.127646903035548E+02) Weight for this step=-.18730E+00 0.54276E+01 beta (00000289)=0.127646903035548E+02 gamma(00000289)=0.127646903035548E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 289 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000289)=0.000000000000000E+00 (calc=0.134266705456058E+02 read=0.134266705456058E+02) Weight for this step=0.16519E+00 -.41709E+01 beta (00000290)=0.134266705456058E+02 gamma(00000290)=0.134266705456058E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 290 z1= 1 -.501231307185227E-03 0.000000000000000E+00 z1= 2 0.170229397171819E-05 0.000000000000000E+00 z1= 3 -.927082524705670E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000290)=0.000000000000000E+00 (calc=0.127607097628115E+02 read=0.127607097628115E+02) Weight for this step=0.18643E+00 -.53633E+01 beta (00000291)=0.127607097628115E+02 gamma(00000291)=0.127607097628115E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 291 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000291)=0.000000000000000E+00 (calc=0.131977142963550E+02 read=0.131977142963550E+02) Weight for this step=-.16382E+00 0.41134E+01 beta (00000292)=0.131977142963550E+02 gamma(00000292)=0.131977142963550E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 292 z1= 1 0.625364817681611E-03 0.000000000000000E+00 z1= 2 -.172943302225326E-05 0.000000000000000E+00 z1= 3 0.944091772866199E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000292)=0.000000000000000E+00 (calc=0.126412174553989E+02 read=0.126412174553989E+02) Weight for this step=-.18869E+00 0.53897E+01 beta (00000293)=0.126412174553989E+02 gamma(00000293)=0.126412174553989E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 293 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000293)=0.000000000000000E+00 (calc=0.135269290528757E+02 read=0.135269290528757E+02) Weight for this step=0.16084E+00 -.40154E+01 beta (00000294)=0.135269290528757E+02 gamma(00000294)=0.135269290528757E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 294 z1= 1 -.725894581670368E-03 0.000000000000000E+00 z1= 2 0.167999408139628E-05 0.000000000000000E+00 z1= 3 -.913283330750174E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000294)=0.000000000000000E+00 (calc=0.129785084256467E+02 read=0.129785084256467E+02) Weight for this step=0.18441E+00 -.52311E+01 beta (00000295)=0.129785084256467E+02 gamma(00000295)=0.129785084256467E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 295 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000295)=0.000000000000000E+00 (calc=0.135622808660767E+02 read=0.135622808660767E+02) Weight for this step=-.15793E+00 0.39213E+01 beta (00000296)=0.135622808660767E+02 gamma(00000296)=0.135622808660767E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 296 z1= 1 0.768668939927513E-03 0.000000000000000E+00 z1= 2 -.168504087478920E-05 0.000000000000000E+00 z1= 3 0.904610650385811E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000296)=0.000000000000000E+00 (calc=0.127907360467252E+02 read=0.127907360467252E+02) Weight for this step=-.18439E+00 0.51952E+01 beta (00000297)=0.127907360467252E+02 gamma(00000297)=0.127907360467252E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 297 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000297)=0.000000000000000E+00 (calc=0.133436968774994E+02 read=0.133436968774994E+02) Weight for this step=0.15761E+00 -.38919E+01 beta (00000298)=0.133436968774994E+02 gamma(00000298)=0.133436968774994E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 298 z1= 1 -.707517468788372E-03 0.000000000000000E+00 z1= 2 0.167961114446585E-05 0.000000000000000E+00 z1= 3 -.902354954200336E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000298)=0.000000000000000E+00 (calc=0.130107129409987E+02 read=0.130107129409987E+02) Weight for this step=0.18477E+00 -.51708E+01 beta (00000299)=0.130107129409987E+02 gamma(00000299)=0.130107129409987E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 299 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000299)=0.000000000000000E+00 (calc=0.136889181088334E+02 read=0.136889181088334E+02) Weight for this step=-.15195E+00 0.37314E+01 beta (00000300)=0.136889181088334E+02 gamma(00000300)=0.136889181088334E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 300 z1= 1 0.684628564601643E-03 0.000000000000000E+00 z1= 2 -.167450096307713E-05 0.000000000000000E+00 z1= 3 0.890878449962199E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000300)=0.000000000000000E+00 (calc=0.127325812475916E+02 read=0.127325812475916E+02) Weight for this step=-.18316E+00 0.50931E+01 beta (00000301)=0.127325812475916E+02 gamma(00000301)=0.127325812475916E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 301 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000301)=0.000000000000000E+00 (calc=0.132014509478762E+02 read=0.132014509478762E+02) Weight for this step=0.15355E+00 -.37498E+01 beta (00000302)=0.132014509478762E+02 gamma(00000302)=0.132014509478762E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 302 z1= 1 -.647264218641776E-03 0.000000000000000E+00 z1= 2 0.168245271964414E-05 0.000000000000000E+00 z1= 3 -.907227271594309E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000302)=0.000000000000000E+00 (calc=0.127870314741178E+02 read=0.127870314741178E+02) Weight for this step=0.18455E+00 -.50981E+01 beta (00000303)=0.127870314741178E+02 gamma(00000303)=0.127870314741178E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 303 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000303)=0.000000000000000E+00 (calc=0.135647539958655E+02 read=0.135647539958655E+02) Weight for this step=-.14868E+00 0.36104E+01 beta (00000304)=0.135647539958655E+02 gamma(00000304)=0.135647539958655E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 304 z1= 1 0.551174922374189E-03 0.000000000000000E+00 z1= 2 -.166716131768264E-05 0.000000000000000E+00 z1= 3 0.898177204541504E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000304)=0.000000000000000E+00 (calc=0.128308768304114E+02 read=0.128308768304114E+02) Weight for this step=-.18141E+00 0.49800E+01 beta (00000305)=0.128308768304114E+02 gamma(00000305)=0.128308768304114E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 305 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000305)=0.000000000000000E+00 (calc=0.134495322428984E+02 read=0.134495322428984E+02) Weight for this step=0.14754E+00 -.35628E+01 beta (00000306)=0.134495322428984E+02 gamma(00000306)=0.134495322428984E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 306 z1= 1 -.426471941304514E-03 0.000000000000000E+00 z1= 2 0.167530919078498E-05 0.000000000000000E+00 z1= 3 -.898344154649051E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000306)=0.000000000000000E+00 (calc=0.127987523275910E+02 read=0.127987523275910E+02) Weight for this step=0.18051E+00 -.49244E+01 beta (00000307)=0.127987523275910E+02 gamma(00000307)=0.127987523275910E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 307 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000307)=0.000000000000000E+00 (calc=0.135696281772165E+02 read=0.135696281772165E+02) Weight for this step=-.14543E+00 0.34921E+01 beta (00000308)=0.135696281772165E+02 gamma(00000308)=0.135696281772165E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 308 z1= 1 0.239679137762927E-03 0.000000000000000E+00 z1= 2 -.166928034521507E-05 0.000000000000000E+00 z1= 3 0.883921430587672E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000308)=0.000000000000000E+00 (calc=0.127885451319368E+02 read=0.127885451319368E+02) Weight for this step=-.17753E+00 0.48131E+01 beta (00000309)=0.127885451319368E+02 gamma(00000309)=0.127885451319368E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 309 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000309)=0.000000000000000E+00 (calc=0.133077725039452E+02 read=0.133077725039452E+02) Weight for this step=0.14484E+00 -.34591E+01 beta (00000310)=0.133077725039452E+02 gamma(00000310)=0.133077725039452E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 310 z1= 1 -.705333776744449E-04 0.000000000000000E+00 z1= 2 0.168442483215736E-05 0.000000000000000E+00 z1= 3 -.877754750090915E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000310)=0.000000000000000E+00 (calc=0.127286690674846E+02 read=0.127286690674846E+02) Weight for this step=0.17799E+00 -.47954E+01 beta (00000311)=0.127286690674846E+02 gamma(00000311)=0.127286690674846E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 311 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000311)=0.000000000000000E+00 (calc=0.134430704842425E+02 read=0.134430704842425E+02) Weight for this step=-.14190E+00 0.33699E+01 beta (00000312)=0.134430704842425E+02 gamma(00000312)=0.134430704842425E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 312 z1= 1 -.739457855190775E-04 0.000000000000000E+00 z1= 2 -.168671184035411E-05 0.000000000000000E+00 z1= 3 0.863265367378064E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000312)=0.000000000000000E+00 (calc=0.128578466093019E+02 read=0.128578466093019E+02) Weight for this step=-.17569E+00 0.47046E+01 beta (00000313)=0.128578466093019E+02 gamma(00000313)=0.128578466093019E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 313 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000313)=0.000000000000000E+00 (calc=0.132261696234449E+02 read=0.132261696234449E+02) Weight for this step=0.13905E+00 -.32837E+01 beta (00000314)=0.132261696234449E+02 gamma(00000314)=0.132261696234449E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 314 z1= 1 0.259106840937338E-03 0.000000000000000E+00 z1= 2 0.174612297445414E-05 0.000000000000000E+00 z1= 3 -.880522102286621E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000314)=0.000000000000000E+00 (calc=0.124474650226159E+02 read=0.124474650226159E+02) Weight for this step=0.17793E+00 -.47361E+01 beta (00000315)=0.124474650226159E+02 gamma(00000315)=0.124474650226159E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 315 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000315)=0.000000000000000E+00 (calc=0.134572319185595E+02 read=0.134572319185595E+02) Weight for this step=-.13801E+00 0.32401E+01 beta (00000316)=0.134572319185595E+02 gamma(00000316)=0.134572319185595E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 316 z1= 1 -.404013283161572E-03 0.000000000000000E+00 z1= 2 -.172059706885202E-05 0.000000000000000E+00 z1= 3 0.855679319318914E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000316)=0.000000000000000E+00 (calc=0.125627927332960E+02 read=0.125627927332960E+02) Weight for this step=-.17153E+00 0.45384E+01 beta (00000317)=0.125627927332960E+02 gamma(00000317)=0.125627927332960E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 317 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000317)=0.000000000000000E+00 (calc=0.134454999929261E+02 read=0.134454999929261E+02) Weight for this step=0.13854E+00 -.32343E+01 beta (00000318)=0.134454999929261E+02 gamma(00000318)=0.134454999929261E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 318 z1= 1 0.507457592957055E-03 0.000000000000000E+00 z1= 2 0.171095648101964E-05 0.000000000000000E+00 z1= 3 -.844837863351596E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000318)=0.000000000000000E+00 (calc=0.125691239725402E+02 read=0.125691239725402E+02) Weight for this step=0.16725E+00 -.43979E+01 beta (00000319)=0.125691239725402E+02 gamma(00000319)=0.125691239725402E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 319 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000319)=0.000000000000000E+00 (calc=0.132683726820441E+02 read=0.132683726820441E+02) Weight for this step=-.13914E+00 0.32308E+01 beta (00000320)=0.132683726820441E+02 gamma(00000320)=0.132683726820441E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 320 z1= 1 -.613713715599071E-03 0.000000000000000E+00 z1= 2 -.173509690408599E-05 0.000000000000000E+00 z1= 3 0.850311119251720E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000320)=0.000000000000000E+00 (calc=0.128768070499523E+02 read=0.128768070499523E+02) Weight for this step=-.16555E+00 0.43255E+01 beta (00000321)=0.128768070499523E+02 gamma(00000321)=0.128768070499523E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 321 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000321)=0.000000000000000E+00 (calc=0.135396593777757E+02 read=0.135396593777757E+02) Weight for this step=0.13462E+00 -.31092E+01 beta (00000322)=0.135396593777757E+02 gamma(00000322)=0.135396593777757E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 322 z1= 1 0.611543137083495E-03 0.000000000000000E+00 z1= 2 0.178307841021625E-05 0.000000000000000E+00 z1= 3 -.859418121421248E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000322)=0.000000000000000E+00 (calc=0.127480205076653E+02 read=0.127480205076653E+02) Weight for this step=0.16418E+00 -.42640E+01 beta (00000323)=0.127480205076653E+02 gamma(00000323)=0.127480205076653E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 323 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000323)=0.000000000000000E+00 (calc=0.132686642269067E+02 read=0.132686642269067E+02) Weight for this step=-.13422E+00 0.30833E+01 beta (00000324)=0.132686642269067E+02 gamma(00000324)=0.132686642269067E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 324 z1= 1 -.593314845552301E-03 0.000000000000000E+00 z1= 2 -.183057700232285E-05 0.000000000000000E+00 z1= 3 0.867850659601235E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000324)=0.000000000000000E+00 (calc=0.127942811383426E+02 read=0.127942811383426E+02) Weight for this step=-.16459E+00 0.42488E+01 beta (00000325)=0.127942811383426E+02 gamma(00000325)=0.127942811383426E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 325 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000325)=0.000000000000000E+00 (calc=0.137027023470101E+02 read=0.137027023470101E+02) Weight for this step=0.13044E+00 -.29803E+01 beta (00000326)=0.137027023470101E+02 gamma(00000326)=0.137027023470101E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 326 z1= 1 0.515212369671513E-03 0.000000000000000E+00 z1= 2 0.183480101835281E-05 0.000000000000000E+00 z1= 3 -.846344731333308E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000326)=0.000000000000000E+00 (calc=0.126562954374660E+02 read=0.126562954374660E+02) Weight for this step=0.16013E+00 -.41095E+01 beta (00000327)=0.126562954374660E+02 gamma(00000327)=0.126562954374660E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 327 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000327)=0.000000000000000E+00 (calc=0.132710996838658E+02 read=0.132710996838658E+02) Weight for this step=-.13262E+00 0.30141E+01 beta (00000328)=0.132710996838658E+02 gamma(00000328)=0.132710996838658E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 328 z1= 1 -.372274808167227E-03 0.000000000000000E+00 z1= 2 -.186608044493272E-05 0.000000000000000E+00 z1= 3 0.850178972784855E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000328)=0.000000000000000E+00 (calc=0.128093992635456E+02 read=0.128093992635456E+02) Weight for this step=-.15948E+00 0.40678E+01 beta (00000329)=0.128093992635456E+02 gamma(00000329)=0.128093992635456E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 329 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000329)=0.000000000000000E+00 (calc=0.136222241652883E+02 read=0.136222241652883E+02) Weight for this step=0.12893E+00 -.29149E+01 beta (00000330)=0.136222241652883E+02 gamma(00000330)=0.136222241652883E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 330 z1= 1 0.204264921806225E-03 0.000000000000000E+00 z1= 2 0.188766628584649E-05 0.000000000000000E+00 z1= 3 -.844127140023669E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000330)=0.000000000000000E+00 (calc=0.126670299839844E+02 read=0.126670299839844E+02) Weight for this step=0.15637E+00 -.39651E+01 beta (00000331)=0.126670299839844E+02 gamma(00000331)=0.126670299839844E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 331 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000331)=0.000000000000000E+00 (calc=0.133665217959362E+02 read=0.133665217959362E+02) Weight for this step=-.13026E+00 0.29298E+01 beta (00000332)=0.133665217959362E+02 gamma(00000332)=0.133665217959362E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 332 z1= 1 0.520216036462105E-05 0.000000000000000E+00 z1= 2 -.191074840630930E-05 0.000000000000000E+00 z1= 3 0.845879706850574E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000332)=0.000000000000000E+00 (calc=0.128362235644113E+02 read=0.128362235644113E+02) Weight for this step=-.15479E+00 0.39011E+01 beta (00000333)=0.128362235644113E+02 gamma(00000333)=0.128362235644113E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 333 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000333)=0.000000000000000E+00 (calc=0.134610383860623E+02 read=0.134610383860623E+02) Weight for this step=0.12744E+00 -.28519E+01 beta (00000334)=0.134610383860623E+02 gamma(00000334)=0.134610383860623E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 334 z1= 1 -.149650802662429E-03 0.000000000000000E+00 z1= 2 0.196738899235186E-05 0.000000000000000E+00 z1= 3 -.858442704595758E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000334)=0.000000000000000E+00 (calc=0.124678202754767E+02 read=0.124678202754767E+02) Weight for this step=0.15401E+00 -.38587E+01 beta (00000335)=0.124678202754767E+02 gamma(00000335)=0.124678202754767E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 335 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000335)=0.000000000000000E+00 (calc=0.130935940616502E+02 read=0.130935940616502E+02) Weight for this step=-.12920E+00 0.28765E+01 beta (00000336)=0.130935940616502E+02 gamma(00000336)=0.130935940616502E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 336 z1= 1 0.268216931856626E-03 0.000000000000000E+00 z1= 2 -.201212838823583E-05 0.000000000000000E+00 z1= 3 0.877588814945625E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000336)=0.000000000000000E+00 (calc=0.129076797325912E+02 read=0.129076797325912E+02) Weight for this step=-.15333E+00 0.38181E+01 beta (00000337)=0.129076797325912E+02 gamma(00000337)=0.129076797325912E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 337 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000337)=0.000000000000000E+00 (calc=0.135012897044665E+02 read=0.135012897044665E+02) Weight for this step=0.12299E+00 -.27243E+01 beta (00000338)=0.135012897044665E+02 gamma(00000338)=0.135012897044665E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 338 z1= 1 -.430209631911072E-03 0.000000000000000E+00 z1= 2 0.207654465792266E-05 0.000000000000000E+00 z1= 3 -.895674804104519E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000338)=0.000000000000000E+00 (calc=0.126384611130740E+02 read=0.126384611130740E+02) Weight for this step=0.15275E+00 -.37823E+01 beta (00000339)=0.126384611130740E+02 gamma(00000339)=0.126384611130740E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 339 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000339)=0.000000000000000E+00 (calc=0.132422097886978E+02 read=0.132422097886978E+02) Weight for this step=-.12317E+00 0.27145E+01 beta (00000340)=0.132422097886978E+02 gamma(00000340)=0.132422097886978E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 340 z1= 1 0.595729902942817E-03 0.000000000000000E+00 z1= 2 -.212817026103108E-05 0.000000000000000E+00 z1= 3 0.918078602631545E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000340)=0.000000000000000E+00 (calc=0.126707155267549E+02 read=0.126707155267549E+02) Weight for this step=-.15208E+00 0.37440E+01 beta (00000341)=0.126707155267549E+02 gamma(00000341)=0.126707155267549E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 341 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000341)=0.000000000000000E+00 (calc=0.136753650270820E+02 read=0.136753650270820E+02) Weight for this step=0.12057E+00 -.26435E+01 beta (00000342)=0.136753650270820E+02 gamma(00000342)=0.136753650270820E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 342 z1= 1 -.712211639774271E-03 0.000000000000000E+00 z1= 2 0.211863388211732E-05 0.000000000000000E+00 z1= 3 -.913338079441568E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000342)=0.000000000000000E+00 (calc=0.127943575652756E+02 read=0.127943575652756E+02) Weight for this step=0.14688E+00 -.35955E+01 beta (00000343)=0.127943575652756E+02 gamma(00000343)=0.127943575652756E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 343 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000343)=0.000000000000000E+00 (calc=0.135431220570199E+02 read=0.135431220570199E+02) Weight for this step=-.12108E+00 0.26416E+01 beta (00000344)=0.135431220570199E+02 gamma(00000344)=0.135431220570199E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 344 z1= 1 0.857869650971173E-03 0.000000000000000E+00 z1= 2 -.212353928338307E-05 0.000000000000000E+00 z1= 3 0.934068680687915E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000344)=0.000000000000000E+00 (calc=0.129527933240723E+02 read=0.129527933240723E+02) Weight for this step=-.14480E+00 0.35244E+01 beta (00000345)=0.129527933240723E+02 gamma(00000345)=0.129527933240723E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 345 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000345)=0.000000000000000E+00 (calc=0.134551236265833E+02 read=0.134551236265833E+02) Weight for this step=0.11901E+00 -.25838E+01 beta (00000346)=0.134551236265833E+02 gamma(00000346)=0.134551236265833E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 346 z1= 1 -.104506027257694E-02 0.000000000000000E+00 z1= 2 0.220131595046681E-05 0.000000000000000E+00 z1= 3 -.961738683013743E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000346)=0.000000000000000E+00 (calc=0.125651899825453E+02 read=0.125651899825453E+02) Weight for this step=0.14538E+00 -.35185E+01 beta (00000347)=0.125651899825453E+02 gamma(00000347)=0.125651899825453E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 347 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000347)=0.000000000000000E+00 (calc=0.134783820689339E+02 read=0.134783820689339E+02) Weight for this step=-.11959E+00 0.25836E+01 beta (00000348)=0.134783820689339E+02 gamma(00000348)=0.134783820689339E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 348 z1= 1 0.116939543831404E-02 0.000000000000000E+00 z1= 2 -.219128906567192E-05 0.000000000000000E+00 z1= 3 0.964487218542664E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000348)=0.000000000000000E+00 (calc=0.129739915427084E+02 read=0.129739915427084E+02) Weight for this step=-.14153E+00 0.34056E+01 beta (00000349)=0.129739915427084E+02 gamma(00000349)=0.129739915427084E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 349 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000349)=0.000000000000000E+00 (calc=0.134297645172635E+02 read=0.134297645172635E+02) Weight for this step=0.11683E+00 -.25122E+01 beta (00000350)=0.134297645172635E+02 gamma(00000350)=0.134297645172635E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 350 z1= 1 -.135344050491708E-02 0.000000000000000E+00 z1= 2 0.225620922337903E-05 0.000000000000000E+00 z1= 3 -.993135379438910E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000350)=0.000000000000000E+00 (calc=0.125508321934906E+02 read=0.125508321934906E+02) Weight for this step=0.14261E+00 -.34124E+01 beta (00000351)=0.125508321934906E+02 gamma(00000351)=0.125508321934906E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 351 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000351)=0.000000000000000E+00 (calc=0.134338381526123E+02 read=0.134338381526123E+02) Weight for this step=-.11730E+00 0.25101E+01 beta (00000352)=0.134338381526123E+02 gamma(00000352)=0.134338381526123E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 352 z1= 1 0.143549901670042E-02 0.000000000000000E+00 z1= 2 -.223606631252283E-05 0.000000000000000E+00 z1= 3 0.100483244686549E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000352)=0.000000000000000E+00 (calc=0.129530888503404E+02 read=0.129530888503404E+02) Weight for this step=-.13914E+00 0.33104E+01 beta (00000353)=0.129530888503404E+02 gamma(00000353)=0.129530888503404E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 353 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000353)=0.000000000000000E+00 (calc=0.132873546681447E+02 read=0.132873546681447E+02) Weight for this step=0.11437E+00 -.24360E+01 beta (00000354)=0.132873546681447E+02 gamma(00000354)=0.132873546681447E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 354 z1= 1 -.157560451699969E-02 0.000000000000000E+00 z1= 2 0.233852346108281E-05 0.000000000000000E+00 z1= 3 -.105125643002821E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000354)=0.000000000000000E+00 (calc=0.124749146209501E+02 read=0.124749146209501E+02) Weight for this step=0.14145E+00 -.33472E+01 beta (00000355)=0.124749146209501E+02 gamma(00000355)=0.124749146209501E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 355 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000355)=0.000000000000000E+00 (calc=0.136129809099013E+02 read=0.136129809099013E+02) Weight for this step=-.11413E+00 0.24190E+01 beta (00000356)=0.136129809099013E+02 gamma(00000356)=0.136129809099013E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 356 z1= 1 0.166791202542283E-02 0.000000000000000E+00 z1= 2 -.227875773599492E-05 0.000000000000000E+00 z1= 3 0.102586970335061E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000356)=0.000000000000000E+00 (calc=0.128740517007964E+02 read=0.128740517007964E+02) Weight for this step=-.13529E+00 0.31837E+01 beta (00000357)=0.128740517007964E+02 gamma(00000357)=0.128740517007964E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 357 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000357)=0.000000000000000E+00 (calc=0.136854129722098E+02 read=0.136854129722098E+02) Weight for this step=0.11355E+00 -.23960E+01 beta (00000358)=0.136854129722098E+02 gamma(00000358)=0.136854129722098E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 358 z1= 1 -.178715673182855E-02 0.000000000000000E+00 z1= 2 0.230669507012221E-05 0.000000000000000E+00 z1= 3 -.104555659559359E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000358)=0.000000000000000E+00 (calc=0.126594210883743E+02 read=0.126594210883743E+02) Weight for this step=0.13288E+00 -.31095E+01 beta (00000359)=0.126594210883743E+02 gamma(00000359)=0.126594210883743E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 359 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000359)=0.000000000000000E+00 (calc=0.138515727051040E+02 read=0.138515727051040E+02) Weight for this step=-.11564E+00 0.24294E+01 beta (00000360)=0.138515727051040E+02 gamma(00000360)=0.138515727051040E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 360 z1= 1 0.183603267132077E-02 0.000000000000000E+00 z1= 2 -.227569132071155E-05 0.000000000000000E+00 z1= 3 0.103527777123977E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000360)=0.000000000000000E+00 (calc=0.124128308764972E+02 read=0.124128308764972E+02) Weight for this step=-.12708E+00 0.29567E+01 beta (00000361)=0.124128308764972E+02 gamma(00000361)=0.124128308764972E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 361 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000361)=0.000000000000000E+00 (calc=0.134328018602647E+02 read=0.134328018602647E+02) Weight for this step=0.12210E+00 -.25551E+01 beta (00000362)=0.134328018602647E+02 gamma(00000362)=0.134328018602647E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 362 z1= 1 -.191581550953614E-02 0.000000000000000E+00 z1= 2 0.230707324347162E-05 0.000000000000000E+00 z1= 3 -.104547600964828E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000362)=0.000000000000000E+00 (calc=0.128797689027868E+02 read=0.128797689027868E+02) Weight for this step=0.12357E+00 -.28567E+01 beta (00000363)=0.128797689027868E+02 gamma(00000363)=0.128797689027868E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 363 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000363)=0.000000000000000E+00 (calc=0.135103476712929E+02 read=0.135103476712929E+02) Weight for this step=-.12084E+00 0.25196E+01 beta (00000364)=0.135103476712929E+02 gamma(00000364)=0.135103476712929E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 364 z1= 1 0.201942123581042E-02 0.000000000000000E+00 z1= 2 -.240656018803912E-05 0.000000000000000E+00 z1= 3 0.108763236745510E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000364)=0.000000000000000E+00 (calc=0.122994663697766E+02 read=0.122994663697766E+02) Weight for this step=-.12385E+00 0.28454E+01 beta (00000365)=0.122994663697766E+02 gamma(00000365)=0.122994663697766E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 365 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000365)=0.000000000000000E+00 (calc=0.129062964166017E+02 read=0.129062964166017E+02) Weight for this step=0.12592E+00 -.26163E+01 beta (00000366)=0.129062964166017E+02 gamma(00000366)=0.129062964166017E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 366 z1= 1 -.211650740536665E-02 0.000000000000000E+00 z1= 2 0.252452689484053E-05 0.000000000000000E+00 z1= 3 -.114127949265371E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000366)=0.000000000000000E+00 (calc=0.127034717271188E+02 read=0.127034717271188E+02) Weight for this step=0.12461E+00 -.28443E+01 beta (00000367)=0.127034717271188E+02 gamma(00000367)=0.127034717271188E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 367 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000367)=0.000000000000000E+00 (calc=0.134767217559440E+02 read=0.134767217559440E+02) Weight for this step=-.12128E+00 0.25115E+01 beta (00000368)=0.134767217559440E+02 gamma(00000368)=0.134767217559440E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 368 z1= 1 0.215017449581701E-02 0.000000000000000E+00 z1= 2 -.259678228810246E-05 0.000000000000000E+00 z1= 3 0.117142236059174E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000368)=0.000000000000000E+00 (calc=0.125626745846411E+02 read=0.125626745846411E+02) Weight for this step=-.12354E+00 0.28031E+01 beta (00000369)=0.125626745846411E+02 gamma(00000369)=0.125626745846411E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 369 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000369)=0.000000000000000E+00 (calc=0.133693021903321E+02 read=0.133693021903321E+02) Weight for this step=0.12344E+00 -.25482E+01 beta (00000370)=0.133693021903321E+02 gamma(00000370)=0.133693021903321E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 370 z1= 1 -.212542264123549E-02 0.000000000000000E+00 z1= 2 0.264599046325038E-05 0.000000000000000E+00 z1= 3 -.121023538968813E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000370)=0.000000000000000E+00 (calc=0.128827453195214E+02 read=0.128827453195214E+02) Weight for this step=0.12232E+00 -.27587E+01 beta (00000371)=0.128827453195214E+02 gamma(00000371)=0.128827453195214E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 371 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000371)=0.000000000000000E+00 (calc=0.133106988649915E+02 read=0.133106988649915E+02) Weight for this step=-.12168E+00 0.25042E+01 beta (00000372)=0.133106988649915E+02 gamma(00000372)=0.133106988649915E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 372 z1= 1 0.214724781364811E-02 0.000000000000000E+00 z1= 2 -.278182824089718E-05 0.000000000000000E+00 z1= 3 0.127225826570328E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000372)=0.000000000000000E+00 (calc=0.128999414938028E+02 read=0.128999414938028E+02) Weight for this step=-.12456E+00 0.27932E+01 beta (00000373)=0.128999414938028E+02 gamma(00000373)=0.128999414938028E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 373 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000373)=0.000000000000000E+00 (calc=0.136448728621549E+02 read=0.136448728621549E+02) Weight for this step=0.11901E+00 -.24422E+01 beta (00000374)=0.136448728621549E+02 gamma(00000374)=0.136448728621549E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 374 z1= 1 -.207159507621628E-02 0.000000000000000E+00 z1= 2 0.283230973369001E-05 0.000000000000000E+00 z1= 3 -.130814550814559E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000374)=0.000000000000000E+00 (calc=0.128456626971522E+02 read=0.128456626971522E+02) Weight for this step=0.12365E+00 -.27578E+01 beta (00000375)=0.128456626971522E+02 gamma(00000375)=0.128456626971522E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 375 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000375)=0.000000000000000E+00 (calc=0.131827389552599E+02 read=0.131827389552599E+02) Weight for this step=-.11990E+00 0.24537E+01 beta (00000376)=0.131827389552599E+02 gamma(00000376)=0.131827389552599E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 376 z1= 1 0.196865024943700E-02 0.000000000000000E+00 z1= 2 -.299477034615848E-05 0.000000000000000E+00 z1= 3 0.137676865270939E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000376)=0.000000000000000E+00 (calc=0.130315447151673E+02 read=0.130315447151673E+02) Weight for this step=-.12663E+00 0.28092E+01 beta (00000377)=0.130315447151673E+02 gamma(00000377)=0.130315447151673E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 377 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000377)=0.000000000000000E+00 (calc=0.135748818097699E+02 read=0.135748818097699E+02) Weight for this step=0.11472E+00 -.23410E+01 beta (00000378)=0.135748818097699E+02 gamma(00000378)=0.135748818097699E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 378 z1= 1 -.176140183845043E-02 0.000000000000000E+00 z1= 2 0.308434431514669E-05 0.000000000000000E+00 z1= 3 -.143849278344495E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000378)=0.000000000000000E+00 (calc=0.125824307978207E+02 read=0.125824307978207E+02) Weight for this step=0.12726E+00 -.28096E+01 beta (00000379)=0.125824307978207E+02 gamma(00000379)=0.125824307978207E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 379 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000379)=0.000000000000000E+00 (calc=0.133817946372658E+02 read=0.133817946372658E+02) Weight for this step=-.11692E+00 0.23795E+01 beta (00000380)=0.133817946372658E+02 gamma(00000380)=0.133817946372658E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 380 z1= 1 0.147099362125275E-02 0.000000000000000E+00 z1= 2 -.315388384145672E-05 0.000000000000000E+00 z1= 3 0.146328125509381E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000380)=0.000000000000000E+00 (calc=0.131035164394389E+02 read=0.131035164394389E+02) Weight for this step=-.12556E+00 0.27582E+01 beta (00000381)=0.131035164394389E+02 gamma(00000381)=0.131035164394389E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 381 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000381)=0.000000000000000E+00 (calc=0.134408251144571E+02 read=0.134408251144571E+02) Weight for this step=0.11292E+00 -.22923E+01 beta (00000382)=0.134408251144571E+02 gamma(00000382)=0.134408251144571E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 382 z1= 1 -.127884804987194E-02 0.000000000000000E+00 z1= 2 0.328099606428404E-05 0.000000000000000E+00 z1= 3 -.153020560332215E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000382)=0.000000000000000E+00 (calc=0.129349547448582E+02 read=0.129349547448582E+02) Weight for this step=0.12808E+00 -.28006E+01 beta (00000383)=0.129349547448582E+02 gamma(00000383)=0.129349547448582E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 383 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000383)=0.000000000000000E+00 (calc=0.134943392845839E+02 read=0.134943392845839E+02) Weight for this step=-.11064E+00 0.22402E+01 beta (00000384)=0.134943392845839E+02 gamma(00000384)=0.134943392845839E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 384 z1= 1 0.111254869272987E-02 0.000000000000000E+00 z1= 2 -.337802323723468E-05 0.000000000000000E+00 z1= 3 0.155372437106612E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000384)=0.000000000000000E+00 (calc=0.126532948766842E+02 read=0.126532948766842E+02) Weight for this step=-.12830E+00 0.27931E+01 beta (00000385)=0.126532948766842E+02 gamma(00000385)=0.126532948766842E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 385 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000385)=0.000000000000000E+00 (calc=0.130168829791860E+02 read=0.130168829791860E+02) Weight for this step=0.11114E+00 -.22446E+01 beta (00000386)=0.130168829791860E+02 gamma(00000386)=0.130168829791860E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 386 z1= 1 -.969093515808193E-03 0.000000000000000E+00 z1= 2 0.349366693629290E-05 0.000000000000000E+00 z1= 3 -.160211226617353E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000386)=0.000000000000000E+00 (calc=0.129062706303159E+02 read=0.129062706303159E+02) Weight for this step=0.13048E+00 -.28280E+01 beta (00000387)=0.129062706303159E+02 gamma(00000387)=0.129062706303159E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 387 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000387)=0.000000000000000E+00 (calc=0.133571549003554E+02 read=0.133571549003554E+02) Weight for this step=-.10525E+00 0.21204E+01 beta (00000388)=0.133571549003554E+02 gamma(00000388)=0.133571549003554E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 388 z1= 1 0.840276174369285E-03 0.000000000000000E+00 z1= 2 -.357727149194421E-05 0.000000000000000E+00 z1= 3 0.162749060299636E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000388)=0.000000000000000E+00 (calc=0.125858293138876E+02 read=0.125858293138876E+02) Weight for this step=-.13139E+00 0.28364E+01 beta (00000389)=0.125858293138876E+02 gamma(00000389)=0.125858293138876E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 389 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000389)=0.000000000000000E+00 (calc=0.134760386903092E+02 read=0.134760386903092E+02) Weight for this step=0.10464E+00 -.21029E+01 beta (00000390)=0.134760386903092E+02 gamma(00000390)=0.134760386903092E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 390 z1= 1 -.731788659172157E-03 0.000000000000000E+00 z1= 2 0.351956976749924E-05 0.000000000000000E+00 z1= 3 -.158862711949898E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000390)=0.000000000000000E+00 (calc=0.129061674007458E+02 read=0.129061674007458E+02) Weight for this step=0.12795E+00 -.27512E+01 beta (00000391)=0.129061674007458E+02 gamma(00000391)=0.129061674007458E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 391 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000391)=0.000000000000000E+00 (calc=0.131950568497570E+02 read=0.131950568497570E+02) Weight for this step=-.10256E+00 0.20562E+01 beta (00000392)=0.131950568497570E+02 gamma(00000392)=0.131950568497570E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 392 z1= 1 0.746036909228398E-03 0.000000000000000E+00 z1= 2 -.362883421400548E-05 0.000000000000000E+00 z1= 3 0.161863361191548E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000392)=0.000000000000000E+00 (calc=0.126542790396239E+02 read=0.126542790396239E+02) Weight for this step=-.13039E+00 0.27930E+01 beta (00000393)=0.126542790396239E+02 gamma(00000393)=0.126542790396239E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 393 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000393)=0.000000000000000E+00 (calc=0.133841508143345E+02 read=0.133841508143345E+02) Weight for this step=0.99977E-01 -.19996E+01 beta (00000394)=0.133841508143345E+02 gamma(00000394)=0.133841508143345E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 394 z1= 1 -.723099031477817E-03 0.000000000000000E+00 z1= 2 0.359631395692277E-05 0.000000000000000E+00 z1= 3 -.158805764730486E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000394)=0.000000000000000E+00 (calc=0.126876710057053E+02 read=0.126876710057053E+02) Weight for this step=0.12832E+00 -.27385E+01 beta (00000395)=0.126876710057053E+02 gamma(00000395)=0.126876710057053E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 395 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000395)=0.000000000000000E+00 (calc=0.132038028396582E+02 read=0.132038028396582E+02) Weight for this step=-.98629E-01 0.19681E+01 beta (00000396)=0.132038028396582E+02 gamma(00000396)=0.132038028396582E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 396 z1= 1 0.635033899586749E-03 0.000000000000000E+00 z1= 2 -.363862670948708E-05 0.000000000000000E+00 z1= 3 0.158564903764754E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000396)=0.000000000000000E+00 (calc=0.127102564059082E+02 read=0.127102564059082E+02) Weight for this step=-.12834E+00 0.27290E+01 beta (00000397)=0.127102564059082E+02 gamma(00000397)=0.127102564059082E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 397 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000397)=0.000000000000000E+00 (calc=0.131579806495601E+02 read=0.131579806495601E+02) Weight for this step=0.95634E-01 -.19040E+01 beta (00000398)=0.131579806495601E+02 gamma(00000398)=0.131579806495601E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 398 z1= 1 -.431202815231577E-03 0.000000000000000E+00 z1= 2 0.367843750192142E-05 0.000000000000000E+00 z1= 3 -.159063400498023E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000398)=0.000000000000000E+00 (calc=0.126877559231659E+02 read=0.126877559231659E+02) Weight for this step=0.12888E+00 -.27308E+01 beta (00000399)=0.126877559231659E+02 gamma(00000399)=0.126877559231659E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 399 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000399)=0.000000000000000E+00 (calc=0.136083917669130E+02 read=0.136083917669130E+02) Weight for this step=-.92314E-01 0.18336E+01 beta (00000400)=0.136083917669130E+02 gamma(00000400)=0.136083917669130E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 400 z1= 1 0.190075065094068E-03 0.000000000000000E+00 z1= 2 -.359823066047558E-05 0.000000000000000E+00 z1= 3 0.154609263904504E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000400)=0.000000000000000E+00 (calc=0.128719340976581E+02 read=0.128719340976581E+02) Weight for this step=-.12474E+00 0.26343E+01 beta (00000401)=0.128719340976581E+02 gamma(00000401)=0.128719340976581E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 401 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000401)=0.000000000000000E+00 (calc=0.132282549626586E+02 read=0.132282549626586E+02) Weight for this step=0.91048E-01 -.18046E+01 beta (00000402)=0.132282549626586E+02 gamma(00000402)=0.132282549626586E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 402 z1= 1 0.834522214406175E-04 0.000000000000000E+00 z1= 2 0.365877063925784E-05 0.000000000000000E+00 z1= 3 -.156010586265041E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000402)=0.000000000000000E+00 (calc=0.129674360628020E+02 read=0.129674360628020E+02) Weight for this step=0.12602E+00 -.26526E+01 beta (00000403)=0.129674360628020E+02 gamma(00000403)=0.129674360628020E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 403 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000403)=0.000000000000000E+00 (calc=0.133464190932160E+02 read=0.133464190932160E+02) Weight for this step=-.86313E-01 0.17070E+01 beta (00000404)=0.133464190932160E+02 gamma(00000404)=0.133464190932160E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 404 z1= 1 -.280664616802044E-03 0.000000000000000E+00 z1= 2 -.371387371356138E-05 0.000000000000000E+00 z1= 3 0.156715869557627E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000404)=0.000000000000000E+00 (calc=0.126603067878984E+02 read=0.126603067878984E+02) Weight for this step=-.12680E+00 0.26610E+01 beta (00000405)=0.126603067878984E+02 gamma(00000405)=0.126603067878984E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 405 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000405)=0.000000000000000E+00 (calc=0.135477429842835E+02 read=0.135477429842835E+02) Weight for this step=0.84224E-01 -.16619E+01 beta (00000406)=0.135477429842835E+02 gamma(00000406)=0.135477429842835E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 406 z1= 1 0.445851546046762E-03 0.000000000000000E+00 z1= 2 0.361801634227404E-05 0.000000000000000E+00 z1= 3 -.151489390767877E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000406)=0.000000000000000E+00 (calc=0.127114680078995E+02 read=0.127114680078995E+02) Weight for this step=0.12269E+00 -.25670E+01 beta (00000407)=0.127114680078995E+02 gamma(00000407)=0.127114680078995E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 407 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000407)=0.000000000000000E+00 (calc=0.130764909171738E+02 read=0.130764909171738E+02) Weight for this step=-.83245E-01 0.16391E+01 beta (00000408)=0.130764909171738E+02 gamma(00000408)=0.130764909171738E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 408 z1= 1 -.686866310734096E-03 0.000000000000000E+00 z1= 2 -.368943701609939E-05 0.000000000000000E+00 z1= 3 0.153817252869596E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000408)=0.000000000000000E+00 (calc=0.129445442339463E+02 read=0.129445442339463E+02) Weight for this step=-.12356E+00 0.25774E+01 beta (00000409)=0.129445442339463E+02 gamma(00000409)=0.129445442339463E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 409 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000409)=0.000000000000000E+00 (calc=0.133572041136436E+02 read=0.133572041136436E+02) Weight for this step=0.77647E-01 -.15255E+01 beta (00000410)=0.133572041136436E+02 gamma(00000410)=0.133572041136436E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 410 z1= 1 0.927455071898040E-03 0.000000000000000E+00 z1= 2 0.374702782119578E-05 0.000000000000000E+00 z1= 3 -.154843940180480E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000410)=0.000000000000000E+00 (calc=0.128095677899156E+02 read=0.128095677899156E+02) Weight for this step=0.12366E+00 -.25725E+01 beta (00000411)=0.128095677899156E+02 gamma(00000411)=0.128095677899156E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 411 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000411)=0.000000000000000E+00 (calc=0.138140861407431E+02 read=0.138140861407431E+02) Weight for this step=-.74446E-01 0.14592E+01 beta (00000412)=0.138140861407431E+02 gamma(00000412)=0.138140861407431E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 412 z1= 1 -.106199446160312E-02 0.000000000000000E+00 z1= 2 -.363388861376619E-05 0.000000000000000E+00 z1= 3 0.150529055998149E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000412)=0.000000000000000E+00 (calc=0.124499136145000E+02 read=0.124499136145000E+02) Weight for this step=-.11830E+00 0.24546E+01 beta (00000413)=0.124499136145000E+02 gamma(00000413)=0.124499136145000E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 413 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000413)=0.000000000000000E+00 (calc=0.133787633226410E+02 read=0.133787633226410E+02) Weight for this step=0.76186E-01 -.14901E+01 beta (00000414)=0.133787633226410E+02 gamma(00000414)=0.133787633226410E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 414 z1= 1 0.111323811915035E-02 0.000000000000000E+00 z1= 2 0.355690483681273E-05 0.000000000000000E+00 z1= 3 -.146614219978774E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000414)=0.000000000000000E+00 (calc=0.130605904309975E+02 read=0.130605904309975E+02) Weight for this step=0.11392E+00 -.23571E+01 beta (00000415)=0.130605904309975E+02 gamma(00000415)=0.130605904309975E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 415 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000415)=0.000000000000000E+00 (calc=0.135228180034523E+02 read=0.135228180034523E+02) Weight for this step=-.72152E-01 0.14082E+01 beta (00000416)=0.135228180034523E+02 gamma(00000416)=0.135228180034523E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 416 z1= 1 -.106535506769477E-02 0.000000000000000E+00 z1= 2 -.360894324256044E-05 0.000000000000000E+00 z1= 3 0.148757284969835E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000416)=0.000000000000000E+00 (calc=0.126275286424197E+02 read=0.126275286424197E+02) Weight for this step=-.11363E+00 0.23447E+01 beta (00000417)=0.126275286424197E+02 gamma(00000417)=0.126275286424197E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 417 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000417)=0.000000000000000E+00 (calc=0.138147967798930E+02 read=0.138147967798930E+02) Weight for this step=0.71191E-01 -.13865E+01 beta (00000418)=0.138147967798930E+02 gamma(00000418)=0.138147967798930E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 418 z1= 1 0.855623342311018E-03 0.000000000000000E+00 z1= 2 0.347840254424090E-05 0.000000000000000E+00 z1= 3 -.142186264193476E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000418)=0.000000000000000E+00 (calc=0.126621244888621E+02 read=0.126621244888621E+02) Weight for this step=0.10734E+00 -.22089E+01 beta (00000419)=0.126621244888621E+02 gamma(00000419)=0.126621244888621E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 419 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000419)=0.000000000000000E+00 (calc=0.135334976896664E+02 read=0.135334976896664E+02) Weight for this step=-.71949E-01 0.13986E+01 beta (00000420)=0.135334976896664E+02 gamma(00000420)=0.135334976896664E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 420 z1= 1 -.679883375782286E-03 0.000000000000000E+00 z1= 2 -.343535056970649E-05 0.000000000000000E+00 z1= 3 0.140527138238778E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000420)=0.000000000000000E+00 (calc=0.128427746894213E+02 read=0.128427746894213E+02) Weight for this step=-.10401E+00 0.21343E+01 beta (00000421)=0.128427746894213E+02 gamma(00000421)=0.128427746894213E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 421 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000421)=0.000000000000000E+00 (calc=0.130972341905300E+02 read=0.130972341905300E+02) Weight for this step=0.70351E-01 -.13650E+01 beta (00000422)=0.130972341905300E+02 gamma(00000422)=0.130972341905300E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 422 z1= 1 0.621546045991187E-03 0.000000000000000E+00 z1= 2 0.355050586750344E-05 0.000000000000000E+00 z1= 3 -.145380588207378E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000422)=0.000000000000000E+00 (calc=0.127561521678028E+02 read=0.127561521678028E+02) Weight for this step=0.10561E+00 -.21610E+01 beta (00000423)=0.127561521678028E+02 gamma(00000423)=0.127561521678028E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 423 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000423)=0.000000000000000E+00 (calc=0.136009918701737E+02 read=0.136009918701737E+02) Weight for this step=-.66643E-01 0.12906E+01 beta (00000424)=0.136009918701737E+02 gamma(00000424)=0.136009918701737E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 424 z1= 1 -.547658655345090E-03 0.000000000000000E+00 z1= 2 -.350312464365539E-05 0.000000000000000E+00 z1= 3 0.143489376920379E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000424)=0.000000000000000E+00 (calc=0.123518097895918E+02 read=0.123518097895918E+02) Weight for this step=-.10235E+00 0.20889E+01 beta (00000425)=0.123518097895918E+02 gamma(00000425)=0.123518097895918E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 425 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000425)=0.000000000000000E+00 (calc=0.137429575264373E+02 read=0.137429575264373E+02) Weight for this step=0.67789E-01 -.13105E+01 beta (00000426)=0.137429575264373E+02 gamma(00000426)=0.137429575264373E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 426 z1= 1 0.422046302059281E-03 0.000000000000000E+00 z1= 2 0.332413442111126E-05 0.000000000000000E+00 z1= 3 -.137278654819390E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000426)=0.000000000000000E+00 (calc=0.127408145603928E+02 read=0.127408145603928E+02) Weight for this step=0.95314E-01 -.19399E+01 beta (00000427)=0.127408145603928E+02 gamma(00000427)=0.127408145603928E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 427 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000427)=0.000000000000000E+00 (calc=0.133045013934137E+02 read=0.133045013934137E+02) Weight for this step=-.68072E-01 0.13139E+01 beta (00000428)=0.133045013934137E+02 gamma(00000428)=0.133045013934137E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 428 z1= 1 -.212886656578828E-03 0.000000000000000E+00 z1= 2 -.336399109907362E-05 0.000000000000000E+00 z1= 3 0.141780779951001E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000428)=0.000000000000000E+00 (calc=0.128353464594813E+02 read=0.128353464594813E+02) Weight for this step=-.94724E-01 0.19223E+01 beta (00000429)=0.128353464594813E+02 gamma(00000429)=0.128353464594813E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 429 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000429)=0.000000000000000E+00 (calc=0.132090488525703E+02 read=0.132090488525703E+02) Weight for this step=0.65580E-01 -.12639E+01 beta (00000430)=0.132090488525703E+02 gamma(00000430)=0.132090488525703E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 430 z1= 1 -.141134921126863E-03 0.000000000000000E+00 z1= 2 0.345564149121158E-05 0.000000000000000E+00 z1= 3 -.145981437012482E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000430)=0.000000000000000E+00 (calc=0.129472393630367E+02 read=0.129472393630367E+02) Weight for this step=0.95390E-01 -.19306E+01 beta (00000431)=0.129472393630367E+02 gamma(00000431)=0.129472393630367E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 431 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000431)=0.000000000000000E+00 (calc=0.135190732045103E+02 read=0.135190732045103E+02) Weight for this step=-.61934E-01 0.11918E+01 beta (00000432)=0.135190732045103E+02 gamma(00000432)=0.135190732045103E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 432 z1= 1 0.469648906546353E-03 0.000000000000000E+00 z1= 2 -.347195752868883E-05 0.000000000000000E+00 z1= 3 0.147050634908619E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000432)=0.000000000000000E+00 (calc=0.125895540199686E+02 read=0.125895540199686E+02) Weight for this step=-.94442E-01 0.19066E+01 beta (00000433)=0.125895540199686E+02 gamma(00000433)=0.125895540199686E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 433 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000433)=0.000000000000000E+00 (calc=0.137837564661999E+02 read=0.137837564661999E+02) Weight for this step=0.61445E-01 -.11807E+01 beta (00000434)=0.137837564661999E+02 gamma(00000434)=0.137837564661999E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 434 z1= 1 -.699355505337226E-03 0.000000000000000E+00 z1= 2 0.333704105134978E-05 0.000000000000000E+00 z1= 3 -.141463466799799E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000434)=0.000000000000000E+00 (calc=0.128837839046491E+02 read=0.128837839046491E+02) Weight for this step=0.89263E-01 -.17975E+01 beta (00000435)=0.128837839046491E+02 gamma(00000435)=0.128837839046491E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 435 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000435)=0.000000000000000E+00 (calc=0.132266241766140E+02 read=0.132266241766140E+02) Weight for this step=-.61062E-01 0.11719E+01 beta (00000436)=0.132266241766140E+02 gamma(00000436)=0.132266241766140E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 436 z1= 1 0.900406287770350E-03 0.000000000000000E+00 z1= 2 -.343402331154331E-05 0.000000000000000E+00 z1= 3 0.147271416023288E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000436)=0.000000000000000E+00 (calc=0.129067969303855E+02 read=0.129067969303855E+02) Weight for this step=-.90060E-01 0.18089E+01 beta (00000437)=0.129067969303855E+02 gamma(00000437)=0.129067969303855E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 437 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000437)=0.000000000000000E+00 (calc=0.128547305937039E+02 read=0.128547305937039E+02) Weight for this step=0.57867E-01 -.11092E+01 beta (00000438)=0.128547305937039E+02 gamma(00000438)=0.128547305937039E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 438 z1= 1 -.935412505457206E-03 0.000000000000000E+00 z1= 2 0.364537805887960E-05 0.000000000000000E+00 z1= 3 -.157846722737736E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000438)=0.000000000000000E+00 (calc=0.127824577418095E+02 read=0.127824577418095E+02) Weight for this step=0.93458E-01 -.18727E+01 beta (00000439)=0.127824577418095E+02 gamma(00000439)=0.127824577418095E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 439 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000439)=0.000000000000000E+00 (calc=0.133184598040274E+02 read=0.133184598040274E+02) Weight for this step=-.53262E-01 0.10195E+01 beta (00000440)=0.133184598040274E+02 gamma(00000440)=0.133184598040274E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 440 z1= 1 0.810557675769655E-03 0.000000000000000E+00 z1= 2 -.369890815444260E-05 0.000000000000000E+00 z1= 3 0.160453326996496E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000440)=0.000000000000000E+00 (calc=0.124654961302202E+02 read=0.124654961302202E+02) Weight for this step=-.92391E-01 0.18474E+01 beta (00000441)=0.124654961302202E+02 gamma(00000441)=0.124654961302202E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 441 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000441)=0.000000000000000E+00 (calc=0.134802936431358E+02 read=0.134802936431358E+02) Weight for this step=0.51906E-01 -.99229E+00 beta (00000442)=0.134802936431358E+02 gamma(00000442)=0.134802936431358E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 442 z1= 1 -.516499840829411E-03 0.000000000000000E+00 z1= 2 0.361668916411522E-05 0.000000000000000E+00 z1= 3 -.157822567910574E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000442)=0.000000000000000E+00 (calc=0.125905811277231E+02 read=0.125905811277231E+02) Weight for this step=0.88030E-01 -.17565E+01 beta (00000443)=0.125905811277231E+02 gamma(00000443)=0.125905811277231E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 443 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000443)=0.000000000000000E+00 (calc=0.133373870821853E+02 read=0.133373870821853E+02) Weight for this step=-.50858E-01 0.97110E+00 beta (00000444)=0.133373870821853E+02 gamma(00000444)=0.133373870821853E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 444 z1= 1 0.180584493924575E-03 0.000000000000000E+00 z1= 2 -.363002011056525E-05 0.000000000000000E+00 z1= 3 0.159138073648553E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000444)=0.000000000000000E+00 (calc=0.132098622582981E+02 read=0.132098622582981E+02) Weight for this step=-.85670E-01 0.17058E+01 beta (00000445)=0.132098622582981E+02 gamma(00000445)=0.132098622582981E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 445 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000445)=0.000000000000000E+00 (calc=0.130285548453076E+02 read=0.130285548453076E+02) Weight for this step=0.46975E-01 -.89595E+00 beta (00000446)=0.130285548453076E+02 gamma(00000446)=0.130285548453076E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 446 z1= 1 0.130021097275945E-03 0.000000000000000E+00 z1= 2 0.390303612414662E-05 0.000000000000000E+00 z1= 3 -.171093881599612E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000446)=0.000000000000000E+00 (calc=0.129522390838715E+02 read=0.129522390838715E+02) Weight for this step=0.89291E-01 -.17746E+01 beta (00000447)=0.129522390838715E+02 gamma(00000447)=0.129522390838715E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 447 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000447)=0.000000000000000E+00 (calc=0.132092080495859E+02 read=0.132092080495859E+02) Weight for this step=-.42602E-01 0.81154E+00 beta (00000448)=0.132092080495859E+02 gamma(00000448)=0.132092080495859E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 448 z1= 1 -.343919605104527E-03 0.000000000000000E+00 z1= 2 -.403725654792454E-05 0.000000000000000E+00 z1= 3 0.176583130495817E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000448)=0.000000000000000E+00 (calc=0.129489703402699E+02 read=0.129489703402699E+02) Weight for this step=-.89727E-01 0.17803E+01 beta (00000449)=0.129489703402699E+02 gamma(00000449)=0.129489703402699E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 449 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000449)=0.000000000000000E+00 (calc=0.136503994660051E+02 read=0.136503994660051E+02) Weight for this step=0.38785E-01 -.73786E+00 beta (00000450)=0.136503994660051E+02 gamma(00000450)=0.136503994660051E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 450 z1= 1 0.462366898619949E-03 0.000000000000000E+00 z1= 2 0.401715509397698E-05 0.000000000000000E+00 z1= 3 -.174798004568964E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000450)=0.000000000000000E+00 (calc=0.124501796398890E+02 read=0.124501796398890E+02) Weight for this step=0.87030E-01 -.17242E+01 beta (00000451)=0.124501796398890E+02 gamma(00000451)=0.124501796398890E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 451 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000451)=0.000000000000000E+00 (calc=0.137434180887783E+02 read=0.137434180887783E+02) Weight for this step=-.37809E-01 0.71835E+00 beta (00000452)=0.137434180887783E+02 gamma(00000452)=0.137434180887783E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 452 z1= 1 -.621808969288577E-03 0.000000000000000E+00 z1= 2 -.382856706656297E-05 0.000000000000000E+00 z1= 3 0.166193210556441E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000452)=0.000000000000000E+00 (calc=0.123493020496221E+02 read=0.123493020496221E+02) Weight for this step=-.80694E-01 0.15962E+01 beta (00000453)=0.123493020496221E+02 gamma(00000453)=0.123493020496221E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 453 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000453)=0.000000000000000E+00 (calc=0.136342995678223E+02 read=0.136342995678223E+02) Weight for this step=0.37671E-01 -.71484E+00 beta (00000454)=0.136342995678223E+02 gamma(00000454)=0.136342995678223E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 454 z1= 1 0.741023024345253E-03 0.000000000000000E+00 z1= 2 0.367567656215598E-05 0.000000000000000E+00 z1= 3 -.159860420652044E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000454)=0.000000000000000E+00 (calc=0.124949139211444E+02 read=0.124949139211444E+02) Weight for this step=0.74949E-01 -.14800E+01 beta (00000455)=0.124949139211444E+02 gamma(00000455)=0.124949139211444E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 455 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000455)=0.000000000000000E+00 (calc=0.136130168730011E+02 read=0.136130168730011E+02) Weight for this step=-.37061E-01 0.70249E+00 beta (00000456)=0.136130168730011E+02 gamma(00000456)=0.136130168730011E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 456 z1= 1 -.936953181289920E-03 0.000000000000000E+00 z1= 2 -.358701196746455E-05 0.000000000000000E+00 z1= 3 0.155583053553236E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000456)=0.000000000000000E+00 (calc=0.127298204930840E+02 read=0.127298204930840E+02) Weight for this step=-.70627E-01 0.13923E+01 beta (00000457)=0.127298204930840E+02 gamma(00000457)=0.127298204930840E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 457 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000457)=0.000000000000000E+00 (calc=0.134663517420900E+02 read=0.134663517420900E+02) Weight for this step=0.35891E-01 -.67965E+00 beta (00000458)=0.134663517420900E+02 gamma(00000458)=0.134663517420900E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 458 z1= 1 0.110744827027448E-02 0.000000000000000E+00 z1= 2 0.361740527831354E-05 0.000000000000000E+00 z1= 3 -.157641902574920E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000458)=0.000000000000000E+00 (calc=0.129361034517672E+02 read=0.129361034517672E+02) Weight for this step=0.68559E-01 -.13491E+01 beta (00000459)=0.129361034517672E+02 gamma(00000459)=0.129361034517672E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 459 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000459)=0.000000000000000E+00 (calc=0.134362693098057E+02 read=0.134362693098057E+02) Weight for this step=-.33789E-01 0.63924E+00 beta (00000460)=0.134362693098057E+02 gamma(00000460)=0.134362693098057E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 460 z1= 1 -.121700640555271E-02 0.000000000000000E+00 z1= 2 -.371424673451318E-05 0.000000000000000E+00 z1= 3 0.160257434332194E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000460)=0.000000000000000E+00 (calc=0.127149949115567E+02 read=0.127149949115567E+02) Weight for this step=-.67701E-01 0.13301E+01 beta (00000461)=0.127149949115567E+02 gamma(00000461)=0.127149949115567E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 461 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000461)=0.000000000000000E+00 (calc=0.133073112577846E+02 read=0.133073112577846E+02) Weight for this step=0.32115E-01 -.60703E+00 beta (00000462)=0.133073112577846E+02 gamma(00000462)=0.133073112577846E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 462 z1= 1 0.123543122794726E-02 0.000000000000000E+00 z1= 2 0.377721131388561E-05 0.000000000000000E+00 z1= 3 -.163677120358614E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000462)=0.000000000000000E+00 (calc=0.130288446758394E+02 read=0.130288446758394E+02) Weight for this step=0.66313E-01 -.13007E+01 beta (00000463)=0.130288446758394E+02 gamma(00000463)=0.130288446758394E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 463 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000463)=0.000000000000000E+00 (calc=0.134211066086419E+02 read=0.134211066086419E+02) Weight for this step=-.29370E-01 0.55466E+00 beta (00000464)=0.134211066086419E+02 gamma(00000464)=0.134211066086419E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 464 z1= 1 -.114517419475710E-02 0.000000000000000E+00 z1= 2 -.389714173639616E-05 0.000000000000000E+00 z1= 3 0.169531651424192E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000464)=0.000000000000000E+00 (calc=0.126554435142617E+02 read=0.126554435142617E+02) Weight for this step=-.65849E-01 0.12898E+01 beta (00000465)=0.126554435142617E+02 gamma(00000465)=0.126554435142617E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 465 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000465)=0.000000000000000E+00 (calc=0.134457802317464E+02 read=0.134457802317464E+02) Weight for this step=0.27639E-01 -.52151E+00 beta (00000466)=0.134457802317464E+02 gamma(00000466)=0.134457802317464E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 466 z1= 1 0.100085258176513E-02 0.000000000000000E+00 z1= 2 0.388267008028572E-05 0.000000000000000E+00 z1= 3 -.170612321031139E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000466)=0.000000000000000E+00 (calc=0.128140918120264E+02 read=0.128140918120264E+02) Weight for this step=0.63363E-01 -.12393E+01 beta (00000467)=0.128140918120264E+02 gamma(00000467)=0.128140918120264E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 467 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000467)=0.000000000000000E+00 (calc=0.136873194631174E+02 read=0.136873194631174E+02) Weight for this step=-.25668E-01 0.48391E+00 beta (00000468)=0.136873194631174E+02 gamma(00000468)=0.136873194631174E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 468 z1= 1 -.837773068858430E-03 0.000000000000000E+00 z1= 2 -.385430773155657E-05 0.000000000000000E+00 z1= 3 0.169608985968987E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000468)=0.000000000000000E+00 (calc=0.126931662935652E+02 read=0.126931662935652E+02) Weight for this step=-.60583E-01 0.11834E+01 beta (00000469)=0.126931662935652E+02 gamma(00000469)=0.126931662935652E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 469 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000469)=0.000000000000000E+00 (calc=0.136810340673466E+02 read=0.136810340673466E+02) Weight for this step=0.24461E-01 -.46079E+00 beta (00000470)=0.136810340673466E+02 gamma(00000470)=0.136810340673466E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 470 z1= 1 0.603029780009937E-03 0.000000000000000E+00 z1= 2 0.380373454803538E-05 0.000000000000000E+00 z1= 3 -.168181379574771E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000470)=0.000000000000000E+00 (calc=0.127563526729678E+02 read=0.127563526729678E+02) Weight for this step=0.57413E-01 -.11200E+01 beta (00000471)=0.127563526729678E+02 gamma(00000471)=0.127563526729678E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 471 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000471)=0.000000000000000E+00 (calc=0.133838544216372E+02 read=0.133838544216372E+02) Weight for this step=-.23200E-01 0.43672E+00 beta (00000472)=0.133838544216372E+02 gamma(00000472)=0.133838544216372E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 472 z1= 1 -.376735457744868E-03 0.000000000000000E+00 z1= 2 -.385232827655995E-05 0.000000000000000E+00 z1= 3 0.170642450942916E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000472)=0.000000000000000E+00 (calc=0.126367553213281E+02 read=0.126367553213281E+02) Weight for this step=-.55888E-01 0.10888E+01 beta (00000473)=0.126367553213281E+02 gamma(00000473)=0.126367553213281E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 473 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000473)=0.000000000000000E+00 (calc=0.134964225133256E+02 read=0.134964225133256E+02) Weight for this step=0.21590E-01 -.40614E+00 beta (00000474)=0.134964225133256E+02 gamma(00000474)=0.134964225133256E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 474 z1= 1 0.138549868665551E-03 0.000000000000000E+00 z1= 2 0.384656455102578E-05 0.000000000000000E+00 z1= 3 -.170023503953855E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000474)=0.000000000000000E+00 (calc=0.127392707719931E+02 read=0.127392707719931E+02) Weight for this step=0.53406E-01 -.10392E+01 beta (00000475)=0.127392707719931E+02 gamma(00000475)=0.127392707719931E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 475 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000475)=0.000000000000000E+00 (calc=0.133043198668531E+02 read=0.133043198668531E+02) Weight for this step=-.20048E-01 0.37689E+00 beta (00000476)=0.133043198668531E+02 gamma(00000476)=0.133043198668531E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 476 z1= 1 -.366766064946022E-05 0.000000000000000E+00 z1= 2 -.393597855522041E-05 0.000000000000000E+00 z1= 3 0.173681874291300E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000476)=0.000000000000000E+00 (calc=0.126415206127251E+02 read=0.126415206127251E+02) Weight for this step=-.52152E-01 0.10136E+01 beta (00000477)=0.126415206127251E+02 gamma(00000477)=0.126415206127251E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 477 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000477)=0.000000000000000E+00 (calc=0.133306174541952E+02 read=0.133306174541952E+02) Weight for this step=0.18318E-01 -.34417E+00 beta (00000478)=0.133306174541952E+02 gamma(00000478)=0.133306174541952E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 478 z1= 1 -.892032300335082E-04 0.000000000000000E+00 z1= 2 0.400478149081840E-05 0.000000000000000E+00 z1= 3 -.176227297179446E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000478)=0.000000000000000E+00 (calc=0.126280448310345E+02 read=0.126280448310345E+02) Weight for this step=0.50382E-01 -.97810E+00 beta (00000479)=0.126280448310345E+02 gamma(00000479)=0.126280448310345E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 479 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000479)=0.000000000000000E+00 (calc=0.133935289410988E+02 read=0.133935289410988E+02) Weight for this step=-.16648E-01 0.31262E+00 beta (00000480)=0.133935289410988E+02 gamma(00000480)=0.133935289410988E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 480 z1= 1 0.171074197255220E-03 0.000000000000000E+00 z1= 2 -.406042373348944E-05 0.000000000000000E+00 z1= 3 0.178952924324762E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000480)=0.000000000000000E+00 (calc=0.126439291117072E+02 read=0.126439291117072E+02) Weight for this step=-.48339E-01 0.93747E+00 beta (00000481)=0.126439291117072E+02 gamma(00000481)=0.126439291117072E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 481 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000481)=0.000000000000000E+00 (calc=0.134762709232779E+02 read=0.134762709232779E+02) Weight for this step=0.15059E-01 -.28262E+00 beta (00000482)=0.134762709232779E+02 gamma(00000482)=0.134762709232779E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 482 z1= 1 -.274925377297743E-03 0.000000000000000E+00 z1= 2 0.410436959185105E-05 0.000000000000000E+00 z1= 3 -.182160806376714E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000482)=0.000000000000000E+00 (calc=0.127040134614102E+02 read=0.127040134614102E+02) Weight for this step=0.46106E-01 -.89330E+00 beta (00000483)=0.127040134614102E+02 gamma(00000483)=0.127040134614102E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 483 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000483)=0.000000000000000E+00 (calc=0.136554939522722E+02 read=0.136554939522722E+02) Weight for this step=-.13528E-01 0.25378E+00 beta (00000484)=0.136554939522722E+02 gamma(00000484)=0.136554939522722E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 484 z1= 1 0.373545215582915E-03 0.000000000000000E+00 z1= 2 -.411070348120416E-05 0.000000000000000E+00 z1= 3 0.182983376707547E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000484)=0.000000000000000E+00 (calc=0.126719401506223E+02 read=0.126719401506223E+02) Weight for this step=-.43560E-01 0.84322E+00 beta (00000485)=0.126719401506223E+02 gamma(00000485)=0.126719401506223E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 485 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000485)=0.000000000000000E+00 (calc=0.132368022462890E+02 read=0.132368022462890E+02) Weight for this step=0.12261E-01 -.22992E+00 beta (00000486)=0.132368022462890E+02 gamma(00000486)=0.132368022462890E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 486 z1= 1 -.477481808089238E-03 0.000000000000000E+00 z1= 2 0.426980029952445E-05 0.000000000000000E+00 z1= 3 -.189884857320811E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000486)=0.000000000000000E+00 (calc=0.124437256507087E+02 read=0.124437256507087E+02) Weight for this step=0.42325E-01 -.81861E+00 beta (00000487)=0.124437256507087E+02 gamma(00000487)=0.124437256507087E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 487 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000487)=0.000000000000000E+00 (calc=0.134512616801075E+02 read=0.134512616801075E+02) Weight for this step=-.10750E-01 0.20151E+00 beta (00000488)=0.134512616801075E+02 gamma(00000488)=0.134512616801075E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 488 z1= 1 0.507203962256171E-03 0.000000000000000E+00 z1= 2 -.428399820041414E-05 0.000000000000000E+00 z1= 3 0.192127805964527E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000488)=0.000000000000000E+00 (calc=0.128384062570810E+02 read=0.128384062570810E+02) Weight for this step=-.39693E-01 0.76710E+00 beta (00000489)=0.128384062570810E+02 gamma(00000489)=0.128384062570810E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 489 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000489)=0.000000000000000E+00 (calc=0.132658307660352E+02 read=0.132658307660352E+02) Weight for this step=0.91799E-02 -.17202E+00 beta (00000490)=0.132658307660352E+02 gamma(00000490)=0.132658307660352E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 490 z1= 1 -.576552481751443E-03 0.000000000000000E+00 z1= 2 0.450459610865095E-05 0.000000000000000E+00 z1= 3 -.202321591731763E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000490)=0.000000000000000E+00 (calc=0.125999663666642E+02 read=0.125999663666642E+02) Weight for this step=0.38880E-01 -.75087E+00 beta (00000491)=0.125999663666642E+02 gamma(00000491)=0.125999663666642E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 491 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000491)=0.000000000000000E+00 (calc=0.134509673228159E+02 read=0.134509673228159E+02) Weight for this step=-.75855E-02 0.14211E+00 beta (00000492)=0.134509673228159E+02 gamma(00000492)=0.134509673228159E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 492 z1= 1 0.648778494445113E-03 0.000000000000000E+00 z1= 2 -.456359526662784E-05 0.000000000000000E+00 z1= 3 0.206682151953539E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000492)=0.000000000000000E+00 (calc=0.127242785940630E+02 read=0.127242785940630E+02) Weight for this step=-.36800E-01 0.71028E+00 beta (00000493)=0.127242785940630E+02 gamma(00000493)=0.127242785940630E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 493 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000493)=0.000000000000000E+00 (calc=0.132863276692116E+02 read=0.132863276692116E+02) Weight for this step=0.60697E-02 -.11369E+00 beta (00000494)=0.132863276692116E+02 gamma(00000494)=0.132863276692116E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 494 z1= 1 -.798206549711888E-03 0.000000000000000E+00 z1= 2 0.473664903291159E-05 0.000000000000000E+00 z1= 3 -.214869906296312E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000494)=0.000000000000000E+00 (calc=0.124537550776820E+02 read=0.124537550776820E+02) Weight for this step=0.35551E-01 -.68583E+00 beta (00000495)=0.124537550776820E+02 gamma(00000495)=0.124537550776820E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 495 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000495)=0.000000000000000E+00 (calc=0.134982417785749E+02 read=0.134982417785749E+02) Weight for this step=-.45517E-02 0.85240E-01 beta (00000496)=0.134982417785749E+02 gamma(00000496)=0.134982417785749E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 496 z1= 1 0.848248345609175E-03 0.000000000000000E+00 z1= 2 -.471985549351395E-05 0.000000000000000E+00 z1= 3 0.216966278016257E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000496)=0.000000000000000E+00 (calc=0.128385623256766E+02 read=0.128385623256766E+02) Weight for this step=-.33027E-01 0.63690E+00 beta (00000497)=0.128385623256766E+02 gamma(00000497)=0.128385623256766E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 497 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000497)=0.000000000000000E+00 (calc=0.133352450564169E+02 read=0.133352450564169E+02) Weight for this step=0.30521E-02 -.57148E-01 beta (00000498)=0.133352450564169E+02 gamma(00000498)=0.133352450564169E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 498 z1= 1 -.918775332722639E-03 0.000000000000000E+00 z1= 2 0.494101645996366E-05 0.000000000000000E+00 z1= 3 -.225915670947811E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000498)=0.000000000000000E+00 (calc=0.126817758264412E+02 read=0.126817758264412E+02) Weight for this step=0.31951E-01 -.61598E+00 beta (00000499)=0.126817758264412E+02 gamma(00000499)=0.126817758264412E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 499 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000499)=0.000000000000000E+00 (calc=0.134573929259691E+02 read=0.134573929259691E+02) Weight for this step=-.15115E-02 0.28301E-01 beta (00000500)=0.134573929259691E+02 gamma(00000500)=0.134573929259691E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 500 z1= 1 0.105280175071152E-02 0.000000000000000E+00 z1= 2 -.502613189380663E-05 0.000000000000000E+00 z1= 3 0.231648395184443E-05 0.000000000000000E+00 alpha(00000500)=0.000000000000000E+00 (calc=0.127047233585133E+02 read=0.127047233585133E+02) Weight for this step=-.30185E-01 0.58185E+00 beta (00000501)=0.127047233585133E+02 gamma(00000501)=0.127047233585133E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Writing Cube file for response charge density Writing Cube file for response charge density Reading Pre-calculated lanczos coefficents from ./out/ch4-pr.beta_gamma_z.2 500 steps succesfully read for polarization index 2 Calculating response coefficients Resonance frequency mode enabled Charge Response renormalization factor: 0.25096E+05 0.00000E+00 Norm of initial Lanczos vectors= 1.841650183260616 Starting Lanczos loop 2 Lanczos iteration: 1 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal alpha(00000001)=0.000000000000000E+00 (calc=0.171988457792556E+01 read=0.171988457792556E+01) Weight for this step=-.75468E+00 -.25096E+02 beta (00000002)=0.171988457792556E+01 gamma(00000002)=0.171988457792556E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 2 z1= 1 0.317095503346229E-06 0.000000000000000E+00 z1= 2 0.124520367488399E+01 0.000000000000000E+00 z1= 3 -.221874587920010E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000002)=0.000000000000000E+00 (calc=0.476672365619246E+01 read=0.476672365619246E+01) Weight for this step=-.85408E+00 -.95522E+01 beta (00000003)=0.476672365619246E+01 gamma(00000003)=0.476672365619246E+01 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 3 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000003)=0.000000000000000E+00 (calc=0.135455715795192E+02 read=0.135455715795192E+02) Weight for this step=0.15701E+00 0.77430E+01 beta (00000004)=0.135455715795192E+02 gamma(00000004)=0.135455715795192E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 4 z1= 1 -.709927313784567E-07 0.000000000000000E+00 z1= 2 -.355940452122788E+00 0.000000000000000E+00 z1= 3 0.772586761541846E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000004)=0.000000000000000E+00 (calc=0.127184765807348E+02 read=0.127184765807348E+02) Weight for this step=0.30757E+00 0.37356E+01 beta (00000005)=0.127184765807348E+02 gamma(00000005)=0.127184765807348E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 5 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000005)=0.000000000000000E+00 (calc=0.134778691157450E+02 read=0.134778691157450E+02) Weight for this step=-.15169E+00 -.80542E+01 beta (00000006)=0.134778691157450E+02 gamma(00000006)=0.134778691157450E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 6 z1= 1 0.730053106531327E-07 0.000000000000000E+00 z1= 2 0.303457115913058E+00 0.000000000000000E+00 z1= 3 -.747578290290408E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000006)=0.000000000000000E+00 (calc=0.128879296181110E+02 read=0.128879296181110E+02) Weight for this step=-.29701E+00 -.39163E+01 beta (00000007)=0.128879296181110E+02 gamma(00000007)=0.128879296181110E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 7 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000007)=0.000000000000000E+00 (calc=0.133738547890015E+02 read=0.133738547890015E+02) Weight for this step=0.14385E+00 0.82239E+01 beta (00000008)=0.133738547890015E+02 gamma(00000008)=0.133738547890015E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 8 z1= 1 -.816119514679891E-07 0.000000000000000E+00 z1= 2 -.273899857136488E+00 0.000000000000000E+00 z1= 3 0.768114964150616E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000008)=0.000000000000000E+00 (calc=0.128588178651202E+02 read=0.128588178651202E+02) Weight for this step=0.29264E+00 0.41766E+01 beta (00000009)=0.128588178651202E+02 gamma(00000009)=0.128588178651202E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 9 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000009)=0.000000000000000E+00 (calc=0.134143960269598E+02 read=0.134143960269598E+02) Weight for this step=-.13504E+00 -.83407E+01 beta (00000010)=0.134143960269598E+02 gamma(00000010)=0.134143960269598E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 10 z1= 1 0.754291104654650E-07 0.000000000000000E+00 z1= 2 0.250161989698730E+00 0.000000000000000E+00 z1= 3 -.825824189482131E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000010)=0.000000000000000E+00 (calc=0.128242644456355E+02 read=0.128242644456355E+02) Weight for this step=-.28649E+00 -.44106E+01 beta (00000011)=0.128242644456355E+02 gamma(00000011)=0.128242644456355E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 11 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000011)=0.000000000000000E+00 (calc=0.134762956212125E+02 read=0.134762956212125E+02) Weight for this step=0.12697E+00 0.84994E+01 beta (00000012)=0.134762956212125E+02 gamma(00000012)=0.134762956212125E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 12 z1= 1 -.686604815123507E-07 0.000000000000000E+00 z1= 2 -.228558184186962E+00 0.000000000000000E+00 z1= 3 0.921210706231678E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000012)=0.000000000000000E+00 (calc=0.128064548987133E+02 read=0.128064548987133E+02) Weight for this step=0.27817E+00 0.46101E+01 beta (00000013)=0.128064548987133E+02 gamma(00000013)=0.128064548987133E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 13 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000013)=0.000000000000000E+00 (calc=0.134982181135660E+02 read=0.134982181135660E+02) Weight for this step=-.11975E+00 -.87083E+01 beta (00000014)=0.134982181135660E+02 gamma(00000014)=0.134982181135660E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 14 z1= 1 0.779321323624189E-07 0.000000000000000E+00 z1= 2 0.209175570057953E+00 0.000000000000000E+00 z1= 3 -.102980197003481E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000014)=0.000000000000000E+00 (calc=0.128005733131694E+02 read=0.128005733131694E+02) Weight for this step=-.26907E+00 -.47961E+01 beta (00000015)=0.128005733131694E+02 gamma(00000015)=0.128005733131694E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 15 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000015)=0.000000000000000E+00 (calc=0.134714898429709E+02 read=0.134714898429709E+02) Weight for this step=0.11289E+00 0.89376E+01 beta (00000016)=0.134714898429709E+02 gamma(00000016)=0.134714898429709E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 16 z1= 1 -.953430739662406E-07 0.000000000000000E+00 z1= 2 -.192296924630644E+00 0.000000000000000E+00 z1= 3 0.109468522866031E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000016)=0.000000000000000E+00 (calc=0.127887191118959E+02 read=0.127887191118959E+02) Weight for this step=0.26049E+00 0.49916E+01 beta (00000017)=0.127887191118959E+02 gamma(00000017)=0.127887191118959E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 17 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000017)=0.000000000000000E+00 (calc=0.134266168773043E+02 read=0.134266168773043E+02) Weight for this step=-.10598E+00 -.91592E+01 beta (00000018)=0.134266168773043E+02 gamma(00000018)=0.134266168773043E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 18 z1= 1 0.113936581758699E-06 0.000000000000000E+00 z1= 2 0.177688396510926E+00 0.000000000000000E+00 z1= 3 -.113342019171010E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000018)=0.000000000000000E+00 (calc=0.127825610047418E+02 read=0.127825610047418E+02) Weight for this step=-.25260E+00 -.52010E+01 beta (00000019)=0.127825610047418E+02 gamma(00000019)=0.127825610047418E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 19 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000019)=0.000000000000000E+00 (calc=0.134080222365160E+02 read=0.134080222365160E+02) Weight for this step=0.98789E-01 0.93543E+01 beta (00000020)=0.134080222365160E+02 gamma(00000020)=0.134080222365160E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 20 z1= 1 -.146728120586741E-06 0.000000000000000E+00 z1= 2 -.164706537066261E+00 0.000000000000000E+00 z1= 3 0.117792325749817E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000020)=0.000000000000000E+00 (calc=0.128007392673731E+02 read=0.128007392673731E+02) Weight for this step=0.24494E+00 0.54151E+01 beta (00000021)=0.128007392673731E+02 gamma(00000021)=0.128007392673731E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 21 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000021)=0.000000000000000E+00 (calc=0.134207233641693E+02 read=0.134207233641693E+02) Weight for this step=-.91373E-01 -.95212E+01 beta (00000022)=0.134207233641693E+02 gamma(00000022)=0.134207233641693E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 22 z1= 1 0.167024380028080E-06 0.000000000000000E+00 z1= 2 0.153072861491443E+00 0.000000000000000E+00 z1= 3 -.121038059610338E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000022)=0.000000000000000E+00 (calc=0.128225837684974E+02 read=0.128225837684974E+02) Weight for this step=-.23738E+00 -.56293E+01 beta (00000023)=0.128225837684974E+02 gamma(00000023)=0.128225837684974E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 23 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000023)=0.000000000000000E+00 (calc=0.134332957763461E+02 read=0.134332957763461E+02) Weight for this step=0.83956E-01 0.96779E+01 beta (00000024)=0.134332957763461E+02 gamma(00000024)=0.134332957763461E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 24 z1= 1 -.176792557782159E-06 0.000000000000000E+00 z1= 2 -.142653728557131E+00 0.000000000000000E+00 z1= 3 0.123689271855853E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000024)=0.000000000000000E+00 (calc=0.128311431778952E+02 read=0.128311431778952E+02) Weight for this step=0.22996E+00 0.58450E+01 beta (00000025)=0.128311431778952E+02 gamma(00000025)=0.128311431778952E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 25 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000025)=0.000000000000000E+00 (calc=0.134383831688750E+02 read=0.134383831688750E+02) Weight for this step=-.76620E-01 -.98339E+01 beta (00000026)=0.134383831688750E+02 gamma(00000026)=0.134383831688750E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 26 z1= 1 0.183967533524607E-06 0.000000000000000E+00 z1= 2 0.133198658750813E+00 0.000000000000000E+00 z1= 3 -.128095103200937E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000026)=0.000000000000000E+00 (calc=0.128182273059286E+02 read=0.128182273059286E+02) Weight for this step=-.22256E+00 -.60599E+01 beta (00000027)=0.128182273059286E+02 gamma(00000027)=0.128182273059286E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 27 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000027)=0.000000000000000E+00 (calc=0.134102233713986E+02 read=0.134102233713986E+02) Weight for this step=0.69434E-01 0.10000E+02 beta (00000028)=0.134102233713986E+02 gamma(00000028)=0.134102233713986E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 28 z1= 1 -.178608112573302E-06 0.000000000000000E+00 z1= 2 -.124698214154016E+00 0.000000000000000E+00 z1= 3 0.133910004981484E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000028)=0.000000000000000E+00 (calc=0.127846793859208E+02 read=0.127846793859208E+02) Weight for this step=0.21538E+00 0.62806E+01 beta (00000029)=0.127846793859208E+02 gamma(00000029)=0.127846793859208E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 29 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000029)=0.000000000000000E+00 (calc=0.134134203203856E+02 read=0.134134203203856E+02) Weight for this step=-.62294E-01 -.10168E+02 beta (00000030)=0.134134203203856E+02 gamma(00000030)=0.134134203203856E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 30 z1= 1 0.165186359050475E-06 0.000000000000000E+00 z1= 2 0.116544925857030E+00 0.000000000000000E+00 z1= 3 -.138991716440136E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000030)=0.000000000000000E+00 (calc=0.128191541701642E+02 read=0.128191541701642E+02) Weight for this step=-.20757E+00 -.64824E+01 beta (00000031)=0.128191541701642E+02 gamma(00000031)=0.128191541701642E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 31 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000031)=0.000000000000000E+00 (calc=0.134294004776947E+02 read=0.134294004776947E+02) Weight for this step=0.55088E-01 0.10308E+02 beta (00000032)=0.134294004776947E+02 gamma(00000032)=0.134294004776947E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 32 z1= 1 -.148979236850623E-06 0.000000000000000E+00 z1= 2 -.109214402246848E+00 0.000000000000000E+00 z1= 3 0.141910011273473E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000032)=0.000000000000000E+00 (calc=0.127671189493068E+02 read=0.127671189493068E+02) Weight for this step=0.20005E+00 0.66903E+01 beta (00000033)=0.127671189493068E+02 gamma(00000033)=0.127671189493068E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 33 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000033)=0.000000000000000E+00 (calc=0.133586625210841E+02 read=0.133586625210841E+02) Weight for this step=-.48213E-01 -.10500E+02 beta (00000034)=0.133586625210841E+02 gamma(00000034)=0.133586625210841E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 34 z1= 1 0.126877541625769E-06 0.000000000000000E+00 z1= 2 0.102543667188429E+00 0.000000000000000E+00 z1= 3 -.142386086634128E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000034)=0.000000000000000E+00 (calc=0.127703273146371E+02 read=0.127703273146371E+02) Weight for this step=-.19277E+00 -.69085E+01 beta (00000035)=0.127703273146371E+02 gamma(00000035)=0.127703273146371E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 35 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000035)=0.000000000000000E+00 (calc=0.134311109909508E+02 read=0.134311109909508E+02) Weight for this step=0.41094E-01 0.10629E+02 beta (00000036)=0.134311109909508E+02 gamma(00000036)=0.134311109909508E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 36 z1= 1 -.104744958693594E-06 0.000000000000000E+00 z1= 2 -.958468358224083E-01 0.000000000000000E+00 z1= 3 0.143211536812694E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000036)=0.000000000000000E+00 (calc=0.128060596798497E+02 read=0.128060596798497E+02) Weight for this step=0.18450E+00 0.70867E+01 beta (00000037)=0.128060596798497E+02 gamma(00000037)=0.128060596798497E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 37 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000037)=0.000000000000000E+00 (calc=0.133888964664024E+02 read=0.133888964664024E+02) Weight for this step=-.34222E-01 -.10786E+02 beta (00000038)=0.133888964664024E+02 gamma(00000038)=0.133888964664024E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 38 z1= 1 0.873091918710683E-07 0.000000000000000E+00 z1= 2 0.901624865375250E-01 0.000000000000000E+00 z1= 3 -.145885828891506E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000038)=0.000000000000000E+00 (calc=0.127549640507501E+02 read=0.127549640507501E+02) Weight for this step=-.17734E+00 -.73056E+01 beta (00000039)=0.127549640507501E+02 gamma(00000039)=0.127549640507501E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 39 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000039)=0.000000000000000E+00 (calc=0.133497034707313E+02 read=0.133497034707313E+02) Weight for this step=0.27394E-01 0.10947E+02 beta (00000040)=0.133497034707313E+02 gamma(00000040)=0.133497034707313E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 40 z1= 1 -.698951829591204E-07 0.000000000000000E+00 z1= 2 -.847499566110708E-01 0.000000000000000E+00 z1= 3 0.147333903384960E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000040)=0.000000000000000E+00 (calc=0.126995473557610E+02 read=0.126995473557610E+02) Weight for this step=0.16996E+00 0.75169E+01 beta (00000041)=0.126995473557610E+02 gamma(00000041)=0.126995473557610E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 41 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000041)=0.000000000000000E+00 (calc=0.133246755218828E+02 read=0.133246755218828E+02) Weight for this step=-.20628E-01 -.11120E+02 beta (00000042)=0.133246755218828E+02 gamma(00000042)=0.133246755218828E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 42 z1= 1 0.498886619888436E-07 0.000000000000000E+00 z1= 2 0.794594828241172E-01 0.000000000000000E+00 z1= 3 -.147649236684200E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000042)=0.000000000000000E+00 (calc=0.127528433245273E+02 read=0.127528433245273E+02) Weight for this step=-.16216E+00 -.77105E+01 beta (00000043)=0.127528433245273E+02 gamma(00000043)=0.127528433245273E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 43 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000043)=0.000000000000000E+00 (calc=0.133691964249925E+02 read=0.133691964249925E+02) Weight for this step=0.13834E-01 0.11223E+02 beta (00000044)=0.133691964249925E+02 gamma(00000044)=0.133691964249925E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 44 z1= 1 -.292861221853208E-07 0.000000000000000E+00 z1= 2 -.746051735512792E-01 0.000000000000000E+00 z1= 3 0.148749159504320E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000044)=0.000000000000000E+00 (calc=0.127653057078416E+02 read=0.127653057078416E+02) Weight for this step=0.15453E+00 0.79046E+01 beta (00000045)=0.127653057078416E+02 gamma(00000045)=0.127653057078416E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 45 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000045)=0.000000000000000E+00 (calc=0.134072282335253E+02 read=0.134072282335253E+02) Weight for this step=-.71834E-02 -.11349E+02 beta (00000046)=0.134072282335253E+02 gamma(00000046)=0.134072282335253E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 46 z1= 1 0.171701336100505E-07 0.000000000000000E+00 z1= 2 0.699090961293279E-01 0.000000000000000E+00 z1= 3 -.148317952237357E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000046)=0.000000000000000E+00 (calc=0.127671148415383E+02 read=0.127671148415383E+02) Weight for this step=-.14663E+00 -.80802E+01 beta (00000047)=0.127671148415383E+02 gamma(00000047)=0.127671148415383E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 47 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000047)=0.000000000000000E+00 (calc=0.133557565416867E+02 read=0.133557565416867E+02) Weight for this step=0.65833E-03 0.11503E+02 beta (00000048)=0.133557565416867E+02 gamma(00000048)=0.133557565416867E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 48 z1= 1 -.169327510255411E-07 0.000000000000000E+00 z1= 2 -.657699116567064E-01 0.000000000000000E+00 z1= 3 0.147122826496104E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000048)=0.000000000000000E+00 (calc=0.128436227860017E+02 read=0.128436227860017E+02) Weight for this step=0.13934E+00 0.82879E+01 beta (00000049)=0.128436227860017E+02 gamma(00000049)=0.128436227860017E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 49 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000049)=0.000000000000000E+00 (calc=0.134358300740148E+02 read=0.134358300740148E+02) Weight for this step=0.57719E-02 -.11540E+02 beta (00000050)=0.134358300740148E+02 gamma(00000050)=0.134358300740148E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 50 z1= 1 0.248542599695645E-07 0.000000000000000E+00 z1= 2 0.619291916488800E-01 0.000000000000000E+00 z1= 3 -.145165333555750E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000050)=0.000000000000000E+00 (calc=0.126967571136032E+02 read=0.126967571136032E+02) Weight for this step=-.13206E+00 -.84848E+01 beta (00000051)=0.126967571136032E+02 gamma(00000051)=0.126967571136032E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 51 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000051)=0.000000000000000E+00 (calc=0.132891106491037E+02 read=0.132891106491037E+02) Weight for this step=-.12248E-01 0.11774E+02 beta (00000052)=0.132891106491037E+02 gamma(00000052)=0.132891106491037E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 52 z1= 1 -.378481225847896E-07 0.000000000000000E+00 z1= 2 -.582335685689649E-01 0.000000000000000E+00 z1= 3 0.143065189191736E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000052)=0.000000000000000E+00 (calc=0.127443368135094E+02 read=0.127443368135094E+02) Weight for this step=0.12468E+00 0.86865E+01 beta (00000053)=0.127443368135094E+02 gamma(00000053)=0.127443368135094E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 53 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000053)=0.000000000000000E+00 (calc=0.133131464859936E+02 read=0.133131464859936E+02) Weight for this step=0.18494E-01 -.11831E+02 beta (00000054)=0.133131464859936E+02 gamma(00000054)=0.133131464859936E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 54 z1= 1 0.461469937388694E-07 0.000000000000000E+00 z1= 2 0.549113560100973E-01 0.000000000000000E+00 z1= 3 -.141730531457904E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000054)=0.000000000000000E+00 (calc=0.127443548004699E+02 read=0.127443548004699E+02) Weight for this step=-.11756E+00 -.88971E+01 beta (00000055)=0.127443548004699E+02 gamma(00000055)=0.127443548004699E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 55 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000055)=0.000000000000000E+00 (calc=0.133785371460162E+02 read=0.133785371460162E+02) Weight for this step=-.24660E-01 0.11902E+02 beta (00000056)=0.133785371460162E+02 gamma(00000056)=0.133785371460162E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 56 z1= 1 -.679880394933996E-07 0.000000000000000E+00 z1= 2 -.515461109741360E-01 0.000000000000000E+00 z1= 3 0.140524007826489E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000056)=0.000000000000000E+00 (calc=0.128320518144718E+02 read=0.128320518144718E+02) Weight for this step=0.10989E+00 0.90577E+01 beta (00000057)=0.128320518144718E+02 gamma(00000057)=0.128320518144718E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 57 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000057)=0.000000000000000E+00 (calc=0.134459852093295E+02 read=0.134459852093295E+02) Weight for this step=0.30610E-01 -.11947E+02 beta (00000058)=0.134459852093295E+02 gamma(00000058)=0.134459852093295E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 58 z1= 1 0.919901273644524E-07 0.000000000000000E+00 z1= 2 0.484731575399201E-01 0.000000000000000E+00 z1= 3 -.139602262563842E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000058)=0.000000000000000E+00 (calc=0.127464079340228E+02 read=0.127464079340228E+02) Weight for this step=-.10249E+00 -.92258E+01 beta (00000059)=0.127464079340228E+02 gamma(00000059)=0.127464079340228E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 59 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000059)=0.000000000000000E+00 (calc=0.133328229368031E+02 read=0.133328229368031E+02) Weight for this step=-.36829E-01 0.12129E+02 beta (00000060)=0.133328229368031E+02 gamma(00000060)=0.133328229368031E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 60 z1= 1 -.109058690841990E-06 0.000000000000000E+00 z1= 2 -.457060886903577E-01 0.000000000000000E+00 z1= 3 0.138723136445000E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000060)=0.000000000000000E+00 (calc=0.128405797712576E+02 read=0.128405797712576E+02) Weight for this step=0.95267E-01 0.94155E+01 beta (00000061)=0.128405797712576E+02 gamma(00000061)=0.128405797712576E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 61 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000061)=0.000000000000000E+00 (calc=0.133760307587134E+02 read=0.133760307587134E+02) Weight for this step=0.42365E-01 -.12114E+02 beta (00000062)=0.133760307587134E+02 gamma(00000062)=0.133760307587134E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 62 z1= 1 0.119607928896273E-06 0.000000000000000E+00 z1= 2 0.432737522187715E-01 0.000000000000000E+00 z1= 3 -.138486525455930E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000062)=0.000000000000000E+00 (calc=0.128441833817929E+02 read=0.128441833817929E+02) Weight for this step=-.88474E-01 -.96314E+01 beta (00000063)=0.128441833817929E+02 gamma(00000063)=0.128441833817929E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 63 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000063)=0.000000000000000E+00 (calc=0.134459511560684E+02 read=0.134459511560684E+02) Weight for this step=-.47878E-01 0.12124E+02 beta (00000064)=0.134459511560684E+02 gamma(00000064)=0.134459511560684E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 64 z1= 1 -.131302126016048E-06 0.000000000000000E+00 z1= 2 -.408085549129928E-01 0.000000000000000E+00 z1= 3 0.137677668728294E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000064)=0.000000000000000E+00 (calc=0.128237682408645E+02 read=0.128237682408645E+02) Weight for this step=0.81282E-01 0.97906E+01 beta (00000065)=0.128237682408645E+02 gamma(00000065)=0.128237682408645E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 65 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000065)=0.000000000000000E+00 (calc=0.134804252917022E+02 read=0.134804252917022E+02) Weight for this step=0.53587E-01 -.12213E+02 beta (00000066)=0.134804252917022E+02 gamma(00000066)=0.134804252917022E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 66 z1= 1 0.149661052043903E-06 0.000000000000000E+00 z1= 2 0.383600758947138E-01 0.000000000000000E+00 z1= 3 -.136590048857848E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000066)=0.000000000000000E+00 (calc=0.128621052138649E+02 read=0.128621052138649E+02) Weight for this step=-.73814E-01 -.99067E+01 beta (00000067)=0.128621052138649E+02 gamma(00000067)=0.128621052138649E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 67 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000067)=0.000000000000000E+00 (calc=0.133881810374547E+02 read=0.133881810374547E+02) Weight for this step=-.59149E-01 0.12296E+02 beta (00000068)=0.133881810374547E+02 gamma(00000068)=0.133881810374547E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 68 z1= 1 -.163525421744814E-06 0.000000000000000E+00 z1= 2 -.364112629135434E-01 0.000000000000000E+00 z1= 3 0.136798831157706E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000068)=0.000000000000000E+00 (calc=0.128152881081528E+02 read=0.128152881081528E+02) Weight for this step=0.67104E-01 0.10119E+02 beta (00000069)=0.128152881081528E+02 gamma(00000069)=0.128152881081528E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 69 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000069)=0.000000000000000E+00 (calc=0.133445162234548E+02 read=0.133445162234548E+02) Weight for this step=0.64431E-01 -.12328E+02 beta (00000070)=0.133445162234548E+02 gamma(00000070)=0.133445162234548E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 70 z1= 1 0.173594029687215E-06 0.000000000000000E+00 z1= 2 0.345810617992865E-01 0.000000000000000E+00 z1= 3 -.137036961219599E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000070)=0.000000000000000E+00 (calc=0.128069654390537E+02 read=0.128069654390537E+02) Weight for this step=-.60358E-01 -.10322E+02 beta (00000071)=0.128069654390537E+02 gamma(00000071)=0.128069654390537E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 71 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000071)=0.000000000000000E+00 (calc=0.134042175660074E+02 read=0.134042175660074E+02) Weight for this step=-.69415E-01 0.12318E+02 beta (00000072)=0.134042175660074E+02 gamma(00000072)=0.134042175660074E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 72 z1= 1 -.178560118785538E-06 0.000000000000000E+00 z1= 2 -.326967507624420E-01 0.000000000000000E+00 z1= 3 0.137764026259337E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000072)=0.000000000000000E+00 (calc=0.128627103435083E+02 read=0.128627103435083E+02) Weight for this step=0.53360E-01 0.10464E+02 beta (00000073)=0.128627103435083E+02 gamma(00000073)=0.128627103435083E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 73 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000073)=0.000000000000000E+00 (calc=0.133230421565322E+02 read=0.133230421565322E+02) Weight for this step=0.74239E-01 -.12304E+02 beta (00000074)=0.133230421565322E+02 gamma(00000074)=0.133230421565322E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 74 z1= 1 0.184907377091294E-06 0.000000000000000E+00 z1= 2 0.313036663230153E-01 0.000000000000000E+00 z1= 3 -.139086514727791E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000074)=0.000000000000000E+00 (calc=0.127141926236090E+02 read=0.127141926236090E+02) Weight for this step=-.46945E-01 -.10707E+02 beta (00000075)=0.127141926236090E+02 gamma(00000075)=0.127141926236090E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 75 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000075)=0.000000000000000E+00 (calc=0.133868799514664E+02 read=0.133868799514664E+02) Weight for this step=-.79369E-01 0.12342E+02 beta (00000076)=0.133868799514664E+02 gamma(00000076)=0.133868799514664E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 76 z1= 1 -.193991818937204E-06 0.000000000000000E+00 z1= 2 -.294637377373356E-01 0.000000000000000E+00 z1= 3 0.138195377978655E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000076)=0.000000000000000E+00 (calc=0.127641760166157E+02 read=0.127641760166157E+02) Weight for this step=0.39783E-01 0.10772E+02 beta (00000077)=0.127641760166157E+02 gamma(00000077)=0.127641760166157E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 77 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000077)=0.000000000000000E+00 (calc=0.133755111186527E+02 read=0.133755111186527E+02) Weight for this step=0.84438E-01 -.12392E+02 beta (00000078)=0.133755111186527E+02 gamma(00000078)=0.133755111186527E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 78 z1= 1 0.212422084499599E-06 0.000000000000000E+00 z1= 2 0.278746852743967E-01 0.000000000000000E+00 z1= 3 -.138139065226158E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000078)=0.000000000000000E+00 (calc=0.128262846599938E+02 read=0.128262846599938E+02) Weight for this step=-.32906E-01 -.10886E+02 beta (00000079)=0.128262846599938E+02 gamma(00000079)=0.128262846599938E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 79 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000079)=0.000000000000000E+00 (calc=0.133316309140939E+02 read=0.133316309140939E+02) Weight for this step=-.88884E-01 0.12367E+02 beta (00000080)=0.133316309140939E+02 gamma(00000080)=0.133316309140939E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 80 z1= 1 -.238116441914765E-06 0.000000000000000E+00 z1= 2 -.266560706334089E-01 0.000000000000000E+00 z1= 3 0.138883427769733E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000080)=0.000000000000000E+00 (calc=0.127857315191969E+02 read=0.127857315191969E+02) Weight for this step=0.26366E-01 0.11081E+02 beta (00000081)=0.127857315191969E+02 gamma(00000081)=0.127857315191969E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 81 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000081)=0.000000000000000E+00 (calc=0.133994485616234E+02 read=0.133994485616234E+02) Weight for this step=0.93162E-01 -.12328E+02 beta (00000082)=0.133994485616234E+02 gamma(00000082)=0.133994485616234E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 82 z1= 1 0.261379095076175E-06 0.000000000000000E+00 z1= 2 0.253065704606500E-01 0.000000000000000E+00 z1= 3 -.138007917961614E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000082)=0.000000000000000E+00 (calc=0.128396988936722E+02 read=0.128396988936722E+02) Weight for this step=-.19687E-01 -.11176E+02 beta (00000083)=0.128396988936722E+02 gamma(00000083)=0.128396988936722E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 83 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000083)=0.000000000000000E+00 (calc=0.133717655748668E+02 read=0.133717655748668E+02) Weight for this step=-.97357E-01 0.12295E+02 beta (00000084)=0.133717655748668E+02 gamma(00000084)=0.133717655748668E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 84 z1= 1 -.299694735311426E-06 0.000000000000000E+00 z1= 2 -.241731604964774E-01 0.000000000000000E+00 z1= 3 0.139771944255543E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000084)=0.000000000000000E+00 (calc=0.128117722162302E+02 read=0.128117722162302E+02) Weight for this step=0.13219E-01 0.11333E+02 beta (00000085)=0.128117722162302E+02 gamma(00000085)=0.128117722162302E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 85 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000085)=0.000000000000000E+00 (calc=0.133218183651525E+02 read=0.133218183651525E+02) Weight for this step=0.10140E+00 -.12254E+02 beta (00000086)=0.133218183651525E+02 gamma(00000086)=0.133218183651525E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 86 z1= 1 0.339226551236346E-06 0.000000000000000E+00 z1= 2 0.231491536005950E-01 0.000000000000000E+00 z1= 3 -.140894538631421E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000086)=0.000000000000000E+00 (calc=0.127545874553951E+02 read=0.127545874553951E+02) Weight for this step=-.68100E-02 -.11501E+02 beta (00000087)=0.127545874553951E+02 gamma(00000087)=0.127545874553951E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 87 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000087)=0.000000000000000E+00 (calc=0.133435620186961E+02 read=0.133435620186961E+02) Weight for this step=-.10536E+00 0.12209E+02 beta (00000088)=0.133435620186961E+02 gamma(00000088)=0.133435620186961E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 88 z1= 1 -.372445508644952E-06 0.000000000000000E+00 z1= 2 -.220543469972217E-01 0.000000000000000E+00 z1= 3 0.142933213310742E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000088)=0.000000000000000E+00 (calc=0.128929975471714E+02 read=0.128929975471714E+02) Weight for this step=0.42576E-03 0.11592E+02 beta (00000089)=0.128929975471714E+02 gamma(00000089)=0.128929975471714E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 89 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000089)=0.000000000000000E+00 (calc=0.133924346230501E+02 read=0.133924346230501E+02) Weight for this step=0.10817E+00 -.12047E+02 beta (00000090)=0.133924346230501E+02 gamma(00000090)=0.133924346230501E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 90 z1= 1 0.407696640183919E-06 0.000000000000000E+00 z1= 2 0.211833571167313E-01 0.000000000000000E+00 z1= 3 -.145124077793012E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000090)=0.000000000000000E+00 (calc=0.126659757914214E+02 read=0.126659757914214E+02) Weight for this step=0.57766E-02 -.11749E+02 beta (00000091)=0.126659757914214E+02 gamma(00000091)=0.126659757914214E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 91 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000091)=0.000000000000000E+00 (calc=0.133458518882292E+02 read=0.133458518882292E+02) Weight for this step=-.11314E+00 0.12130E+02 beta (00000092)=0.133458518882292E+02 gamma(00000092)=0.133458518882292E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 92 z1= 1 -.422207161879587E-06 0.000000000000000E+00 z1= 2 -.200864253774463E-01 0.000000000000000E+00 z1= 3 0.143193876756646E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000092)=0.000000000000000E+00 (calc=0.127909393086097E+02 read=0.127909393086097E+02) Weight for this step=-.11941E-01 0.11745E+02 beta (00000093)=0.127909393086097E+02 gamma(00000093)=0.127909393086097E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 93 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000093)=0.000000000000000E+00 (calc=0.133461372887160E+02 read=0.133461372887160E+02) Weight for this step=0.11652E+00 -.12056E+02 beta (00000094)=0.133461372887160E+02 gamma(00000094)=0.133461372887160E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 94 z1= 1 0.451993989596632E-06 0.000000000000000E+00 z1= 2 0.192790328978661E-01 0.000000000000000E+00 z1= 3 -.142333575930900E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000094)=0.000000000000000E+00 (calc=0.127865790361712E+02 read=0.127865790361712E+02) Weight for this step=0.18062E-01 -.11848E+02 beta (00000095)=0.127865790361712E+02 gamma(00000095)=0.127865790361712E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 95 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000095)=0.000000000000000E+00 (calc=0.133901025233023E+02 read=0.133901025233023E+02) Weight for this step=-.11977E+00 0.11977E+02 beta (00000096)=0.133901025233023E+02 gamma(00000096)=0.133901025233023E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 96 z1= 1 -.478290603350348E-06 0.000000000000000E+00 z1= 2 -.184170333309770E-01 0.000000000000000E+00 z1= 3 0.140676661283801E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000096)=0.000000000000000E+00 (calc=0.127921040309578E+02 read=0.127921040309578E+02) Weight for this step=-.23998E-01 0.11899E+02 beta (00000097)=0.127921040309578E+02 gamma(00000097)=0.127921040309578E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 97 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000097)=0.000000000000000E+00 (calc=0.134509429182819E+02 read=0.134509429182819E+02) Weight for this step=0.12321E+00 -.11928E+02 beta (00000098)=0.134509429182819E+02 gamma(00000098)=0.134509429182819E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 98 z1= 1 0.494522844262432E-06 0.000000000000000E+00 z1= 2 0.175091771023050E-01 0.000000000000000E+00 z1= 3 -.138281774661643E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000098)=0.000000000000000E+00 (calc=0.130150737030773E+02 read=0.130150737030773E+02) Weight for this step=0.29705E-01 -.11897E+02 beta (00000099)=0.130150737030773E+02 gamma(00000099)=0.130150737030773E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 99 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000099)=0.000000000000000E+00 (calc=0.136149118803897E+02 read=0.136149118803897E+02) Weight for this step=-.12493E+00 0.11729E+02 beta (00000100)=0.136149118803897E+02 gamma(00000100)=0.136149118803897E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 100 z1= 1 -.515944330635584E-06 0.000000000000000E+00 z1= 2 -.167547814377519E-01 0.000000000000000E+00 z1= 3 0.135140861642918E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000100)=0.000000000000000E+00 (calc=0.127969530262333E+02 read=0.127969530262333E+02) Weight for this step=-.35265E-01 0.11937E+02 beta (00000101)=0.127969530262333E+02 gamma(00000101)=0.127969530262333E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 101 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000101)=0.000000000000000E+00 (calc=0.132882473664145E+02 read=0.132882473664145E+02) Weight for this step=0.13018E+00 -.11868E+02 beta (00000102)=0.132882473664145E+02 gamma(00000102)=0.132882473664145E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 102 z1= 1 0.541037656784978E-06 0.000000000000000E+00 z1= 2 0.161799091177460E-01 0.000000000000000E+00 z1= 3 -.132541389902046E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000102)=0.000000000000000E+00 (calc=0.128815671989160E+02 read=0.128815671989160E+02) Weight for this step=0.41267E-01 -.12080E+02 beta (00000103)=0.128815671989160E+02 gamma(00000103)=0.128815671989160E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 103 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000103)=0.000000000000000E+00 (calc=0.134147783842160E+02 read=0.134147783842160E+02) Weight for this step=-.13125E+00 0.11628E+02 beta (00000104)=0.134147783842160E+02 gamma(00000104)=0.134147783842160E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 104 z1= 1 -.562748091265759E-06 0.000000000000000E+00 z1= 2 -.156274762717688E-01 0.000000000000000E+00 z1= 3 0.130035414217335E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000104)=0.000000000000000E+00 (calc=0.128778630469479E+02 read=0.128778630469479E+02) Weight for this step=-.46898E-01 0.12167E+02 beta (00000105)=0.128778630469479E+02 gamma(00000105)=0.128778630469479E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 105 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000105)=0.000000000000000E+00 (calc=0.132659039721740E+02 read=0.132659039721740E+02) Weight for this step=0.13340E+00 -.11495E+02 beta (00000106)=0.132659039721740E+02 gamma(00000106)=0.132659039721740E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 106 z1= 1 0.593544908862728E-06 0.000000000000000E+00 z1= 2 0.152720209886075E-01 0.000000000000000E+00 z1= 3 -.129754339370095E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000106)=0.000000000000000E+00 (calc=0.126949441298188E+02 read=0.126949441298188E+02) Weight for this step=0.52975E-01 -.12379E+02 beta (00000107)=0.126949441298188E+02 gamma(00000107)=0.126949441298188E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 107 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000107)=0.000000000000000E+00 (calc=0.133395828396943E+02 read=0.133395828396943E+02) Weight for this step=-.13569E+00 0.11374E+02 beta (00000108)=0.133395828396943E+02 gamma(00000108)=0.133395828396943E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 108 z1= 1 -.620124458342291E-06 0.000000000000000E+00 z1= 2 -.145900525657302E-01 0.000000000000000E+00 z1= 3 0.126921295439840E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000108)=0.000000000000000E+00 (calc=0.128482733291928E+02 read=0.128482733291928E+02) Weight for this step=-.57926E-01 0.12339E+02 beta (00000109)=0.128482733291928E+02 gamma(00000109)=0.128482733291928E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 109 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000109)=0.000000000000000E+00 (calc=0.133217672248390E+02 read=0.133217672248390E+02) Weight for this step=0.13697E+00 -.11180E+02 beta (00000110)=0.133217672248390E+02 gamma(00000110)=0.133217672248390E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 110 z1= 1 0.654445692239080E-06 0.000000000000000E+00 z1= 2 0.141245704249187E-01 0.000000000000000E+00 z1= 3 -.124051828349404E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000110)=0.000000000000000E+00 (calc=0.126967111362054E+02 read=0.126967111362054E+02) Weight for this step=0.63437E-01 -.12449E+02 beta (00000111)=0.126967111362054E+02 gamma(00000111)=0.126967111362054E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 111 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000111)=0.000000000000000E+00 (calc=0.135206919879961E+02 read=0.135206919879961E+02) Weight for this step=-.13946E+00 0.11088E+02 beta (00000112)=0.135206919879961E+02 gamma(00000112)=0.135206919879961E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 112 z1= 1 -.682143865366348E-06 0.000000000000000E+00 z1= 2 -.133228025881830E-01 0.000000000000000E+00 z1= 3 0.118177153908409E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000112)=0.000000000000000E+00 (calc=0.129787482073338E+02 read=0.129787482073338E+02) Weight for this step=-.67142E-01 0.12227E+02 beta (00000113)=0.129787482073338E+02 gamma(00000113)=0.129787482073338E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 113 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000113)=0.000000000000000E+00 (calc=0.134371977380927E+02 read=0.134371977380927E+02) Weight for this step=0.14095E+00 -.10935E+02 beta (00000114)=0.134371977380927E+02 gamma(00000114)=0.134371977380927E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 114 z1= 1 0.730488856749570E-06 0.000000000000000E+00 z1= 2 0.129010829180915E-01 0.000000000000000E+00 z1= 3 -.115227312497178E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000114)=0.000000000000000E+00 (calc=0.127033480997902E+02 read=0.127033480997902E+02) Weight for this step=0.72532E-01 -.12343E+02 beta (00000115)=0.127033480997902E+02 gamma(00000115)=0.127033480997902E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 115 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000115)=0.000000000000000E+00 (calc=0.135069839916071E+02 read=0.135069839916071E+02) Weight for this step=-.14439E+00 0.10930E+02 beta (00000116)=0.135069839916071E+02 gamma(00000116)=0.135069839916071E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 116 z1= 1 -.761276688108136E-06 0.000000000000000E+00 z1= 2 -.122154973439061E-01 0.000000000000000E+00 z1= 3 0.108452864458800E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000116)=0.000000000000000E+00 (calc=0.127083365075967E+02 read=0.127083365075967E+02) Weight for this step=-.76023E-01 0.12138E+02 beta (00000117)=0.127083365075967E+02 gamma(00000117)=0.127083365075967E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 117 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000117)=0.000000000000000E+00 (calc=0.132506525370431E+02 read=0.132506525370431E+02) Weight for this step=0.14859E+00 -.10992E+02 beta (00000118)=0.132506525370431E+02 gamma(00000118)=0.132506525370431E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 118 z1= 1 0.814196278609925E-06 0.000000000000000E+00 z1= 2 0.118297492061078E-01 0.000000000000000E+00 z1= 3 -.103772403622438E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000118)=0.000000000000000E+00 (calc=0.127948300566571E+02 read=0.127948300566571E+02) Weight for this step=0.81082E-01 -.12185E+02 beta (00000119)=0.127948300566571E+02 gamma(00000119)=0.127948300566571E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 119 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000119)=0.000000000000000E+00 (calc=0.133198411447122E+02 read=0.133198411447122E+02) Weight for this step=-.14878E+00 0.10760E+02 beta (00000120)=0.133198411447122E+02 gamma(00000120)=0.133198411447122E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 120 z1= 1 -.855745037019184E-06 0.000000000000000E+00 z1= 2 -.114615360332153E-01 0.000000000000000E+00 z1= 3 0.995054258216355E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000120)=0.000000000000000E+00 (calc=0.125251023324571E+02 read=0.125251023324571E+02) Weight for this step=-.86005E-01 0.12233E+02 beta (00000121)=0.125251023324571E+02 gamma(00000121)=0.125251023324571E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 121 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000121)=0.000000000000000E+00 (calc=0.131931010122391E+02 read=0.131931010122391E+02) Weight for this step=0.15275E+00 -.10804E+02 beta (00000122)=0.131931010122391E+02 gamma(00000122)=0.131931010122391E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 122 z1= 1 0.883531032879695E-06 0.000000000000000E+00 z1= 2 0.109867869934768E-01 0.000000000000000E+00 z1= 3 -.936637162692608E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000122)=0.000000000000000E+00 (calc=0.127053174545164E+02 read=0.127053174545164E+02) Weight for this step=0.90049E-01 -.12150E+02 beta (00000123)=0.127053174545164E+02 gamma(00000123)=0.127053174545164E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 123 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000123)=0.000000000000000E+00 (calc=0.133819599718688E+02 read=0.133819599718688E+02) Weight for this step=-.15302E+00 0.10592E+02 beta (00000124)=0.133819599718688E+02 gamma(00000124)=0.133819599718688E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 124 z1= 1 -.911042491655517E-06 0.000000000000000E+00 z1= 2 -.105063759919598E-01 0.000000000000000E+00 z1= 3 0.868062535213016E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000124)=0.000000000000000E+00 (calc=0.126842079454632E+02 read=0.126842079454632E+02) Weight for this step=-.93772E-01 0.12053E+02 beta (00000125)=0.126842079454632E+02 gamma(00000125)=0.126842079454632E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 125 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000125)=0.000000000000000E+00 (calc=0.133805664687447E+02 read=0.133805664687447E+02) Weight for this step=0.15565E+00 -.10553E+02 beta (00000126)=0.133805664687447E+02 gamma(00000126)=0.133805664687447E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 126 z1= 1 0.935578643005992E-06 0.000000000000000E+00 z1= 2 0.100407847093536E-01 0.000000000000000E+00 z1= 3 -.800555838431291E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000126)=0.000000000000000E+00 (calc=0.128061204619817E+02 read=0.128061204619817E+02) Weight for this step=0.97295E-01 -.11942E+02 beta (00000127)=0.128061204619817E+02 gamma(00000127)=0.128061204619817E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 127 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000127)=0.000000000000000E+00 (calc=0.132907880569990E+02 read=0.132907880569990E+02) Weight for this step=-.15672E+00 0.10416E+02 beta (00000128)=0.132907880569990E+02 gamma(00000128)=0.132907880569990E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 128 z1= 1 -.975654113411720E-06 0.000000000000000E+00 z1= 2 -.973660483386434E-02 0.000000000000000E+00 z1= 3 0.745895181534281E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000128)=0.000000000000000E+00 (calc=0.127747966685744E+02 read=0.127747966685744E+02) Weight for this step=-.10225E+00 0.12020E+02 beta (00000129)=0.127747966685744E+02 gamma(00000129)=0.127747966685744E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 129 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000129)=0.000000000000000E+00 (calc=0.132951250145243E+02 read=0.132951250145243E+02) Weight for this step=0.15687E+00 -.10221E+02 beta (00000130)=0.132951250145243E+02 gamma(00000130)=0.132951250145243E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 130 z1= 1 0.100437339109602E-05 0.000000000000000E+00 z1= 2 0.941463236472839E-02 0.000000000000000E+00 z1= 3 -.677406628535890E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000130)=0.000000000000000E+00 (calc=0.127446356688777E+02 read=0.127446356688777E+02) Weight for this step=0.10674E+00 -.12053E+02 beta (00000131)=0.127446356688777E+02 gamma(00000131)=0.127446356688777E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 131 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000131)=0.000000000000000E+00 (calc=0.131433426333794E+02 read=0.131433426333794E+02) Weight for this step=-.15722E+00 0.10043E+02 beta (00000132)=0.131433426333794E+02 gamma(00000132)=0.131433426333794E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 132 z1= 1 -.103247959823633E-05 0.000000000000000E+00 z1= 2 -.917804786629992E-02 0.000000000000000E+00 z1= 3 0.604218852652549E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000132)=0.000000000000000E+00 (calc=0.127576292684171E+02 read=0.127576292684171E+02) Weight for this step=-.11210E+00 0.12187E+02 beta (00000133)=0.127576292684171E+02 gamma(00000133)=0.127576292684171E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 133 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000133)=0.000000000000000E+00 (calc=0.134670380404582E+02 read=0.134670380404582E+02) Weight for this step=0.15527E+00 -.97215E+01 beta (00000134)=0.134670380404582E+02 gamma(00000134)=0.134670380404582E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 134 z1= 1 0.102849093916359E-05 0.000000000000000E+00 z1= 2 0.869350866361398E-02 0.000000000000000E+00 z1= 3 -.518605317934907E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000134)=0.000000000000000E+00 (calc=0.127762132248046E+02 read=0.127762132248046E+02) Weight for this step=0.11446E+00 -.12018E+02 beta (00000135)=0.127762132248046E+02 gamma(00000135)=0.127762132248046E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 135 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000135)=0.000000000000000E+00 (calc=0.134260226782820E+02 read=0.134260226782820E+02) Weight for this step=-.15686E+00 0.96315E+01 beta (00000136)=0.134260226782820E+02 gamma(00000136)=0.134260226782820E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 136 z1= 1 -.102584878773973E-05 0.000000000000000E+00 z1= 2 -.830312207588573E-02 0.000000000000000E+00 z1= 3 0.433753785011393E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000136)=0.000000000000000E+00 (calc=0.129114184456332E+02 read=0.129114184456332E+02) Weight for this step=-.11729E+00 0.11906E+02 beta (00000137)=0.129114184456332E+02 gamma(00000137)=0.129114184456332E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 137 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000137)=0.000000000000000E+00 (calc=0.133836379120135E+02 read=0.133836379120135E+02) Weight for this step=0.15624E+00 -.94117E+01 beta (00000138)=0.133836379120135E+02 gamma(00000138)=0.133836379120135E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 138 z1= 1 0.103366617286047E-05 0.000000000000000E+00 z1= 2 0.809071070514883E-02 0.000000000000000E+00 z1= 3 -.364009874781479E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000138)=0.000000000000000E+00 (calc=0.129445319033460E+02 read=0.129445319033460E+02) Weight for this step=0.12149E+00 -.11946E+02 beta (00000139)=0.129445319033460E+02 gamma(00000139)=0.129445319033460E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 139 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000139)=0.000000000000000E+00 (calc=0.135470965860482E+02 read=0.135470965860482E+02) Weight for this step=-.15447E+00 0.91269E+01 beta (00000140)=0.135470965860482E+02 gamma(00000140)=0.135470965860482E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 140 z1= 1 -.103779878763343E-05 0.000000000000000E+00 z1= 2 -.782226028085625E-02 0.000000000000000E+00 z1= 3 0.296632566743369E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000140)=0.000000000000000E+00 (calc=0.127278504636548E+02 read=0.127278504636548E+02) Weight for this step=-.12423E+00 0.11856E+02 beta (00000141)=0.127278504636548E+02 gamma(00000141)=0.127278504636548E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 141 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000141)=0.000000000000000E+00 (calc=0.134909219977230E+02 read=0.134909219977230E+02) Weight for this step=0.15710E+00 -.91046E+01 beta (00000142)=0.134909219977230E+02 gamma(00000142)=0.134909219977230E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 142 z1= 1 0.103218787497771E-05 0.000000000000000E+00 z1= 2 0.747261402129886E-02 0.000000000000000E+00 z1= 3 -.211168278339561E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000142)=0.000000000000000E+00 (calc=0.127388173235863E+02 read=0.127388173235863E+02) Weight for this step=0.12550E+00 -.11627E+02 beta (00000143)=0.127388173235863E+02 gamma(00000143)=0.127388173235863E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 143 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000143)=0.000000000000000E+00 (calc=0.134409852480717E+02 read=0.134409852480717E+02) Weight for this step=-.15901E+00 0.90447E+01 beta (00000144)=0.134409852480717E+02 gamma(00000144)=0.134409852480717E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 144 z1= 1 -.103565262227386E-05 0.000000000000000E+00 z1= 2 -.714991515082834E-02 0.000000000000000E+00 z1= 3 0.144201465746610E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000144)=0.000000000000000E+00 (calc=0.129263364384594E+02 read=0.129263364384594E+02) Weight for this step=-.12736E+00 0.11460E+02 beta (00000145)=0.129263364384594E+02 gamma(00000145)=0.129263364384594E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 145 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000145)=0.000000000000000E+00 (calc=0.133955208992933E+02 read=0.133955208992933E+02) Weight for this step=0.15800E+00 -.88245E+01 beta (00000146)=0.133955208992933E+02 gamma(00000146)=0.133955208992933E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 146 z1= 1 0.105951222333892E-05 0.000000000000000E+00 z1= 2 0.694935720809958E-02 0.000000000000000E+00 z1= 3 -.825981350774277E-07 0.000000000000000E+00 Calculating total response charge density alpha(00000146)=0.000000000000000E+00 (calc=0.128294766287082E+02 read=0.128294766287082E+02) Weight for this step=0.13128E+00 -.11490E+02 beta (00000147)=0.128294766287082E+02 gamma(00000147)=0.128294766287082E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 147 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000147)=0.000000000000000E+00 (calc=0.136375174458535E+02 read=0.136375174458535E+02) Weight for this step=-.15738E+00 0.86276E+01 beta (00000148)=0.136375174458535E+02 gamma(00000148)=0.136375174458535E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 148 z1= 1 -.105904615362918E-05 0.000000000000000E+00 z1= 2 -.656973454849849E-02 0.000000000000000E+00 z1= 3 0.312275559188240E-07 0.000000000000000E+00 Calculating total response charge density alpha(00000148)=0.000000000000000E+00 (calc=0.127203037165633E+02 read=0.127203037165633E+02) Weight for this step=-.13169E+00 0.11223E+02 beta (00000149)=0.127203037165633E+02 gamma(00000149)=0.127203037165633E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 149 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000149)=0.000000000000000E+00 (calc=0.135407488726473E+02 read=0.135407488726473E+02) Weight for this step=0.16107E+00 -.86722E+01 beta (00000150)=0.135407488726473E+02 gamma(00000150)=0.135407488726473E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 150 z1= 1 0.106239516298070E-05 0.000000000000000E+00 z1= 2 0.618147335007543E-02 0.000000000000000E+00 z1= 3 0.294653150650936E-07 0.000000000000000E+00 Calculating total response charge density alpha(00000150)=0.000000000000000E+00 (calc=0.126679041497047E+02 read=0.126679041497047E+02) Weight for this step=0.13213E+00 -.10962E+02 beta (00000151)=0.126679041497047E+02 gamma(00000151)=0.126679041497047E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 151 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000151)=0.000000000000000E+00 (calc=0.134957579036312E+02 read=0.134957579036312E+02) Weight for this step=-.16447E+00 0.87032E+01 beta (00000152)=0.134957579036312E+02 gamma(00000152)=0.134957579036312E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 152 z1= 1 -.105917121673857E-05 0.000000000000000E+00 z1= 2 -.579877918204266E-02 0.000000000000000E+00 z1= 3 -.828648795436239E-07 0.000000000000000E+00 Calculating total response charge density alpha(00000152)=0.000000000000000E+00 (calc=0.125471913599242E+02 read=0.125471913599242E+02) Weight for this step=-.13265E+00 0.10712E+02 beta (00000153)=0.125471913599242E+02 gamma(00000153)=0.125471913599242E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 153 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000153)=0.000000000000000E+00 (calc=0.132884917450183E+02 read=0.132884917450183E+02) Weight for this step=0.16913E+00 -.88024E+01 beta (00000154)=0.132884917450183E+02 gamma(00000154)=0.132884917450183E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 154 z1= 1 0.105818799361456E-05 0.000000000000000E+00 z1= 2 0.545214156660806E-02 0.000000000000000E+00 z1= 3 0.142514987836568E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000154)=0.000000000000000E+00 (calc=0.128413064816161E+02 read=0.128413064816161E+02) Weight for this step=0.13425E+00 -.10548E+02 beta (00000155)=0.128413064816161E+02 gamma(00000155)=0.128413064816161E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 155 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000155)=0.000000000000000E+00 (calc=0.133879555574154E+02 read=0.133879555574154E+02) Weight for this step=-.16736E+00 0.85712E+01 beta (00000156)=0.133879555574154E+02 gamma(00000156)=0.133879555574154E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 156 z1= 1 -.107590433559134E-05 0.000000000000000E+00 z1= 2 -.518976300996476E-02 0.000000000000000E+00 z1= 3 -.195539046567834E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000156)=0.000000000000000E+00 (calc=0.128086748716001E+02 read=0.128086748716001E+02) Weight for this step=-.13759E+00 0.10536E+02 beta (00000157)=0.128086748716001E+02 gamma(00000157)=0.128086748716001E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 157 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000157)=0.000000000000000E+00 (calc=0.135343390145841E+02 read=0.135343390145841E+02) Weight for this step=0.16707E+00 -.84204E+01 beta (00000158)=0.135343390145841E+02 gamma(00000158)=0.135343390145841E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 158 z1= 1 0.107946078301783E-05 0.000000000000000E+00 z1= 2 0.482107913855394E-02 0.000000000000000E+00 z1= 3 0.248970499216420E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000158)=0.000000000000000E+00 (calc=0.127047546512039E+02 read=0.127047546512039E+02) Weight for this step=0.13891E+00 -.10379E+02 beta (00000159)=0.127047546512039E+02 gamma(00000159)=0.127047546512039E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 159 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000159)=0.000000000000000E+00 (calc=0.132659523055967E+02 read=0.132659523055967E+02) Weight for this step=-.17001E+00 0.84355E+01 beta (00000160)=0.132659523055967E+02 gamma(00000160)=0.132659523055967E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 160 z1= 1 -.108928314458689E-05 0.000000000000000E+00 z1= 2 -.451839380304038E-02 0.000000000000000E+00 z1= 3 -.313553387191020E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000160)=0.000000000000000E+00 (calc=0.125635431020473E+02 read=0.125635431020473E+02) Weight for this step=-.14206E+00 0.10356E+02 beta (00000161)=0.125635431020473E+02 gamma(00000161)=0.125635431020473E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 161 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000161)=0.000000000000000E+00 (calc=0.133039659354947E+02 read=0.133039659354947E+02) Weight for this step=0.17129E+00 -.83675E+01 beta (00000162)=0.133039659354947E+02 gamma(00000162)=0.133039659354947E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 162 z1= 1 0.107236647758913E-05 0.000000000000000E+00 z1= 2 0.422995649584881E-02 0.000000000000000E+00 z1= 3 0.380006947690680E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000162)=0.000000000000000E+00 (calc=0.127494997661192E+02 read=0.127494997661192E+02) Weight for this step=0.14321E+00 -.10191E+02 beta (00000163)=0.127494997661192E+02 gamma(00000163)=0.127494997661192E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 163 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000163)=0.000000000000000E+00 (calc=0.131751258900873E+02 read=0.131751258900873E+02) Weight for this step=-.17059E+00 0.82082E+01 beta (00000164)=0.131751258900873E+02 gamma(00000164)=0.131751258900873E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 164 z1= 1 -.107931879048378E-05 0.000000000000000E+00 z1= 2 -.411027507129953E-02 0.000000000000000E+00 z1= 3 -.447163887185497E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000164)=0.000000000000000E+00 (calc=0.126038859000492E+02 read=0.126038859000492E+02) Weight for this step=-.14768E+00 0.10270E+02 beta (00000165)=0.126038859000492E+02 gamma(00000165)=0.126038859000492E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 165 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000165)=0.000000000000000E+00 (calc=0.134358658212613E+02 read=0.134358658212613E+02) Weight for this step=0.16983E+00 -.80468E+01 beta (00000166)=0.134358658212613E+02 gamma(00000166)=0.134358658212613E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 166 z1= 1 0.106351077201966E-05 0.000000000000000E+00 z1= 2 0.389749775070855E-02 0.000000000000000E+00 z1= 3 0.491409726466004E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000166)=0.000000000000000E+00 (calc=0.127184558380648E+02 read=0.127184558380648E+02) Weight for this step=0.14741E+00 -.10026E+02 beta (00000167)=0.127184558380648E+02 gamma(00000167)=0.127184558380648E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 167 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000167)=0.000000000000000E+00 (calc=0.134466489729254E+02 read=0.134466489729254E+02) Weight for this step=-.17104E+00 0.79847E+01 beta (00000168)=0.134466489729254E+02 gamma(00000168)=0.134466489729254E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 168 z1= 1 -.106860015988176E-05 0.000000000000000E+00 z1= 2 -.379400611101051E-02 0.000000000000000E+00 z1= 3 -.530242690438841E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000168)=0.000000000000000E+00 (calc=0.127723839590025E+02 read=0.127723839590025E+02) Weight for this step=-.14835E+00 0.98717E+01 beta (00000169)=0.127723839590025E+02 gamma(00000169)=0.127723839590025E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 169 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000169)=0.000000000000000E+00 (calc=0.132923294616541E+02 read=0.132923294616541E+02) Weight for this step=0.17169E+00 -.79003E+01 beta (00000170)=0.132923294616541E+02 gamma(00000170)=0.132923294616541E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 170 z1= 1 0.108191530806068E-05 0.000000000000000E+00 z1= 2 0.375436808835560E-02 0.000000000000000E+00 z1= 3 0.577796892553876E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000170)=0.000000000000000E+00 (calc=0.127568568816318E+02 read=0.127568568816318E+02) Weight for this step=0.15160E+00 -.98746E+01 beta (00000171)=0.127568568816318E+02 gamma(00000171)=0.127568568816318E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 171 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000171)=0.000000000000000E+00 (calc=0.133681871406868E+02 read=0.133681871406868E+02) Weight for this step=-.17034E+00 0.77252E+01 beta (00000172)=0.133681871406868E+02 gamma(00000172)=0.133681871406868E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 172 z1= 1 -.108819182292148E-05 0.000000000000000E+00 z1= 2 -.371256182696771E-02 0.000000000000000E+00 z1= 3 -.634886751288508E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000172)=0.000000000000000E+00 (calc=0.127960423053282E+02 read=0.127960423053282E+02) Weight for this step=-.15358E+00 0.98013E+01 beta (00000173)=0.127960423053282E+02 gamma(00000173)=0.127960423053282E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 173 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000173)=0.000000000000000E+00 (calc=0.134741881015547E+02 read=0.134741881015547E+02) Weight for this step=0.16934E+00 -.75693E+01 beta (00000174)=0.134741881015547E+02 gamma(00000174)=0.134741881015547E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 174 z1= 1 0.109239239843390E-05 0.000000000000000E+00 z1= 2 0.357095355852630E-02 0.000000000000000E+00 z1= 3 0.681469873070563E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000174)=0.000000000000000E+00 (calc=0.128361174105512E+02 read=0.128361174105512E+02) Weight for this step=0.15464E+00 -.96757E+01 beta (00000175)=0.128361174105512E+02 gamma(00000175)=0.128361174105512E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 175 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000175)=0.000000000000000E+00 (calc=0.133955757010337E+02 read=0.133955757010337E+02) Weight for this step=-.16911E+00 0.74521E+01 beta (00000176)=0.133955757010337E+02 gamma(00000176)=0.133955757010337E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 176 z1= 1 -.110311230164814E-05 0.000000000000000E+00 z1= 2 -.335493968454716E-02 0.000000000000000E+00 z1= 3 -.739446794686786E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000176)=0.000000000000000E+00 (calc=0.127371852541013E+02 read=0.127371852541013E+02) Weight for this step=-.15700E+00 0.96358E+01 beta (00000177)=0.127371852541013E+02 gamma(00000177)=0.127371852541013E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 177 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000177)=0.000000000000000E+00 (calc=0.133609366177205E+02 read=0.133609366177205E+02) Weight for this step=0.16903E+00 -.73421E+01 beta (00000178)=0.133609366177205E+02 gamma(00000178)=0.133609366177205E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 178 z1= 1 0.111885057118687E-05 0.000000000000000E+00 z1= 2 0.312200218431379E-02 0.000000000000000E+00 z1= 3 0.791271319925877E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000178)=0.000000000000000E+00 (calc=0.126228657734582E+02 read=0.126228657734582E+02) Weight for this step=0.15850E+00 -.95456E+01 beta (00000179)=0.126228657734582E+02 gamma(00000179)=0.126228657734582E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 179 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000179)=0.000000000000000E+00 (calc=0.134189404990344E+02 read=0.134189404990344E+02) Weight for this step=-.16994E+00 0.72764E+01 beta (00000180)=0.134189404990344E+02 gamma(00000180)=0.134189404990344E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 180 z1= 1 -.111730974403004E-05 0.000000000000000E+00 z1= 2 -.280505210291405E-02 0.000000000000000E+00 z1= 3 -.847025019017240E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000180)=0.000000000000000E+00 (calc=0.127642316802466E+02 read=0.127642316802466E+02) Weight for this step=-.15793E+00 0.93343E+01 beta (00000181)=0.127642316802466E+02 gamma(00000181)=0.127642316802466E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 181 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000181)=0.000000000000000E+00 (calc=0.134409141429390E+02 read=0.134409141429390E+02) Weight for this step=0.16982E+00 -.71710E+01 beta (00000182)=0.134409141429390E+02 gamma(00000182)=0.134409141429390E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 182 z1= 1 0.112232772496923E-05 0.000000000000000E+00 z1= 2 0.252770498377594E-02 0.000000000000000E+00 z1= 3 0.910795989597169E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000182)=0.000000000000000E+00 (calc=0.128179025753085E+02 read=0.128179025753085E+02) Weight for this step=0.15879E+00 -.92136E+01 beta (00000183)=0.128179025753085E+02 gamma(00000183)=0.128179025753085E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 183 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000183)=0.000000000000000E+00 (calc=0.135090366548233E+02 read=0.135090366548233E+02) Weight for this step=-.16925E+00 0.70490E+01 beta (00000184)=0.135090366548233E+02 gamma(00000184)=0.135090366548233E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 184 z1= 1 -.111687856092476E-05 0.000000000000000E+00 z1= 2 -.229158041477047E-02 0.000000000000000E+00 z1= 3 -.984247161710467E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000184)=0.000000000000000E+00 (calc=0.129152285336588E+02 read=0.129152285336588E+02) Weight for this step=-.15939E+00 0.90837E+01 beta (00000185)=0.129152285336588E+02 gamma(00000185)=0.129152285336588E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 185 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000185)=0.000000000000000E+00 (calc=0.133109443639838E+02 read=0.133109443639838E+02) Weight for this step=0.16825E+00 -.69127E+01 beta (00000186)=0.133109443639838E+02 gamma(00000186)=0.133109443639838E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 186 z1= 1 0.113063033166556E-05 0.000000000000000E+00 z1= 2 0.208359887777609E-02 0.000000000000000E+00 z1= 3 0.107145512976423E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000186)=0.000000000000000E+00 (calc=0.127266820868849E+02 read=0.127266820868849E+02) Weight for this step=0.16344E+00 -.91536E+01 beta (00000187)=0.127266820868849E+02 gamma(00000187)=0.127266820868849E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 187 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000187)=0.000000000000000E+00 (calc=0.134537882143667E+02 read=0.134537882143667E+02) Weight for this step=-.16685E+00 0.67592E+01 beta (00000188)=0.134537882143667E+02 gamma(00000188)=0.134537882143667E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 188 z1= 1 -.110250468056232E-05 0.000000000000000E+00 z1= 2 -.185796026025172E-02 0.000000000000000E+00 z1= 3 -.113343429432875E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000188)=0.000000000000000E+00 (calc=0.129513207015717E+02 read=0.129513207015717E+02) Weight for this step=-.16323E+00 0.89878E+01 beta (00000189)=0.129513207015717E+02 gamma(00000189)=0.129513207015717E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 189 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000189)=0.000000000000000E+00 (calc=0.137067210021585E+02 read=0.137067210021585E+02) Weight for this step=0.16438E+00 -.65672E+01 beta (00000190)=0.137067210021585E+02 gamma(00000190)=0.137067210021585E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 190 z1= 1 0.107499442737009E-05 0.000000000000000E+00 z1= 2 0.163471384436023E-02 0.000000000000000E+00 z1= 3 0.116534852662956E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000190)=0.000000000000000E+00 (calc=0.128651907089398E+02 read=0.128651907089398E+02) Weight for this step=0.16256E+00 -.88061E+01 beta (00000191)=0.128651907089398E+02 gamma(00000191)=0.128651907089398E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 191 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000191)=0.000000000000000E+00 (calc=0.134373743593997E+02 read=0.134373743593997E+02) Weight for this step=-.16617E+00 0.65487E+01 beta (00000192)=0.134373743593997E+02 gamma(00000192)=0.134373743593997E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 192 z1= 1 -.105886825545751E-05 0.000000000000000E+00 z1= 2 -.143886348858214E-02 0.000000000000000E+00 z1= 3 -.121411707353785E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000192)=0.000000000000000E+00 (calc=0.127839054630780E+02 read=0.127839054630780E+02) Weight for this step=-.16422E+00 0.87501E+01 beta (00000193)=0.127839054630780E+02 gamma(00000193)=0.127839054630780E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 193 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000193)=0.000000000000000E+00 (calc=0.131981222093619E+02 read=0.131981222093619E+02) Weight for this step=0.16557E+00 -.64354E+01 beta (00000194)=0.131981222093619E+02 gamma(00000194)=0.131981222093619E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 194 z1= 1 0.105305425094444E-05 0.000000000000000E+00 z1= 2 0.131549665139537E-02 0.000000000000000E+00 z1= 3 0.127175235195348E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000194)=0.000000000000000E+00 (calc=0.126839715566835E+02 read=0.126839715566835E+02) Weight for this step=0.16777E+00 -.87947E+01 beta (00000195)=0.126839715566835E+02 gamma(00000195)=0.126839715566835E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 195 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000195)=0.000000000000000E+00 (calc=0.133139850083846E+02 read=0.133139850083846E+02) Weight for this step=-.16293E+00 0.62424E+01 beta (00000196)=0.133139850083846E+02 gamma(00000196)=0.133139850083846E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 196 z1= 1 -.102930308852741E-05 0.000000000000000E+00 z1= 2 -.121596013638692E-02 0.000000000000000E+00 z1= 3 -.131999883206248E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000196)=0.000000000000000E+00 (calc=0.126079514649386E+02 read=0.126079514649386E+02) Weight for this step=-.16831E+00 0.86854E+01 beta (00000197)=0.126079514649386E+02 gamma(00000197)=0.126079514649386E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 197 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000197)=0.000000000000000E+00 (calc=0.136343173950944E+02 read=0.136343173950944E+02) Weight for this step=0.16263E+00 -.61411E+01 beta (00000198)=0.136343173950944E+02 gamma(00000198)=0.136343173950944E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 198 z1= 1 0.981642291674432E-06 0.000000000000000E+00 z1= 2 0.114358291716641E-02 0.000000000000000E+00 z1= 3 0.131332220974995E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000198)=0.000000000000000E+00 (calc=0.126706235348146E+02 read=0.126706235348146E+02) Weight for this step=0.16390E+00 -.83264E+01 beta (00000199)=0.126706235348146E+02 gamma(00000199)=0.126706235348146E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 199 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000199)=0.000000000000000E+00 (calc=0.134978599498391E+02 read=0.134978599498391E+02) Weight for this step=-.16588E+00 0.61780E+01 beta (00000200)=0.134978599498391E+02 gamma(00000200)=0.134978599498391E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 200 z1= 1 -.955347674870414E-06 0.000000000000000E+00 z1= 2 -.113916140398469E-02 0.000000000000000E+00 z1= 3 -.133730305478007E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000200)=0.000000000000000E+00 (calc=0.126143087869868E+02 read=0.126143087869868E+02) Weight for this step=-.16236E+00 0.81157E+01 beta (00000201)=0.126143087869868E+02 gamma(00000201)=0.126143087869868E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 201 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000201)=0.000000000000000E+00 (calc=0.133826767928539E+02 read=0.133826767928539E+02) Weight for this step=0.16843E+00 -.61896E+01 beta (00000202)=0.133826767928539E+02 gamma(00000202)=0.133826767928539E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 202 z1= 1 0.927116197872897E-06 0.000000000000000E+00 z1= 2 0.113989695775037E-02 0.000000000000000E+00 z1= 3 0.133624008330296E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000202)=0.000000000000000E+00 (calc=0.127737830500156E+02 read=0.127737830500156E+02) Weight for this step=0.16173E+00 -.79525E+01 beta (00000203)=0.127737830500156E+02 gamma(00000203)=0.127737830500156E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 203 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000203)=0.000000000000000E+00 (calc=0.135575572400017E+02 read=0.135575572400017E+02) Weight for this step=-.16754E+00 0.60771E+01 beta (00000204)=0.135575572400017E+02 gamma(00000204)=0.135575572400017E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 204 z1= 1 -.896363712115343E-06 0.000000000000000E+00 z1= 2 -.112066319849019E-02 0.000000000000000E+00 z1= 3 -.134432142647400E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000204)=0.000000000000000E+00 (calc=0.128450529322169E+02 read=0.128450529322169E+02) Weight for this step=-.16092E+00 0.77862E+01 beta (00000205)=0.128450529322169E+02 gamma(00000205)=0.128450529322169E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 205 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000205)=0.000000000000000E+00 (calc=0.134791517419749E+02 read=0.134791517419749E+02) Weight for this step=0.16803E+00 -.60174E+01 beta (00000206)=0.134791517419749E+02 gamma(00000206)=0.134791517419749E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 206 z1= 1 0.883322866461348E-06 0.000000000000000E+00 z1= 2 0.117521975788877E-02 0.000000000000000E+00 z1= 3 0.133889799755173E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000206)=0.000000000000000E+00 (calc=0.127620232765468E+02 read=0.127620232765468E+02) Weight for this step=0.16196E+00 -.77121E+01 beta (00000207)=0.127620232765468E+02 gamma(00000207)=0.127620232765468E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 207 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000207)=0.000000000000000E+00 (calc=0.133839133766670E+02 read=0.133839133766670E+02) Weight for this step=-.16856E+00 0.59600E+01 beta (00000208)=0.133839133766670E+02 gamma(00000208)=0.133839133766670E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 208 z1= 1 -.878535337546591E-06 0.000000000000000E+00 z1= 2 -.125146245668752E-02 0.000000000000000E+00 z1= 3 -.133679469833302E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000208)=0.000000000000000E+00 (calc=0.126288010205754E+02 read=0.126288010205754E+02) Weight for this step=-.16312E+00 0.76452E+01 beta (00000209)=0.126288010205754E+02 gamma(00000209)=0.126288010205754E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 209 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000209)=0.000000000000000E+00 (calc=0.135242396688555E+02 read=0.135242396688555E+02) Weight for this step=0.16958E+00 -.59201E+01 beta (00000210)=0.135242396688555E+02 gamma(00000210)=0.135242396688555E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 210 z1= 1 0.873681965328152E-06 0.000000000000000E+00 z1= 2 0.133348372586061E-02 0.000000000000000E+00 z1= 3 0.130806393405496E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000210)=0.000000000000000E+00 (calc=0.126503349545983E+02 read=0.126503349545983E+02) Weight for this step=0.16097E+00 -.74256E+01 beta (00000211)=0.126503349545983E+02 gamma(00000211)=0.126503349545983E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 211 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000211)=0.000000000000000E+00 (calc=0.135864429532374E+02 read=0.135864429532374E+02) Weight for this step=-.17238E+00 0.59448E+01 beta (00000212)=0.135864429532374E+02 gamma(00000212)=0.135864429532374E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 212 z1= 1 -.865499704505706E-06 0.000000000000000E+00 z1= 2 -.134121092682849E-02 0.000000000000000E+00 z1= 3 -.129392508056903E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000212)=0.000000000000000E+00 (calc=0.126859768542068E+02 read=0.126859768542068E+02) Weight for this step=-.15862E+00 0.72004E+01 beta (00000213)=0.126859768542068E+02 gamma(00000213)=0.126859768542068E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 213 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000213)=0.000000000000000E+00 (calc=0.134727092063749E+02 read=0.134727092063749E+02) Weight for this step=0.17586E+00 -.59953E+01 beta (00000214)=0.134727092063749E+02 gamma(00000214)=0.134727092063749E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 214 z1= 1 0.850029226464287E-06 0.000000000000000E+00 z1= 2 0.124209442916493E-02 0.000000000000000E+00 z1= 3 0.130801361068462E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000214)=0.000000000000000E+00 (calc=0.125567704421397E+02 read=0.125567704421397E+02) Weight for this step=0.15835E+00 -.70712E+01 beta (00000215)=0.125567704421397E+02 gamma(00000215)=0.125567704421397E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 215 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000215)=0.000000000000000E+00 (calc=0.132488421462506E+02 read=0.132488421462506E+02) Weight for this step=-.17987E+00 0.60640E+01 beta (00000216)=0.132488421462506E+02 gamma(00000216)=0.132488421462506E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 216 z1= 1 -.851693890188861E-06 0.000000000000000E+00 z1= 2 -.111931306454405E-02 0.000000000000000E+00 z1= 3 -.131337116169493E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000216)=0.000000000000000E+00 (calc=0.124624319850318E+02 read=0.124624319850318E+02) Weight for this step=-.15942E+00 0.70014E+01 beta (00000217)=0.124624319850318E+02 gamma(00000217)=0.124624319850318E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 217 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000217)=0.000000000000000E+00 (calc=0.136513087968110E+02 read=0.136513087968110E+02) Weight for this step=0.18229E+00 -.60789E+01 beta (00000218)=0.136513087968110E+02 gamma(00000218)=0.136513087968110E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 218 z1= 1 0.828443591122628E-06 0.000000000000000E+00 z1= 2 0.927181250573297E-03 0.000000000000000E+00 z1= 3 0.126686686126499E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000218)=0.000000000000000E+00 (calc=0.127274188956597E+02 read=0.127274188956597E+02) Weight for this step=0.15472E+00 -.66831E+01 beta (00000219)=0.127274188956597E+02 gamma(00000219)=0.127274188956597E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 219 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000219)=0.000000000000000E+00 (calc=0.134287314094792E+02 read=0.134287314094792E+02) Weight for this step=-.18703E+00 0.61764E+01 beta (00000220)=0.134287314094792E+02 gamma(00000220)=0.134287314094792E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 220 z1= 1 -.850437689616478E-06 0.000000000000000E+00 z1= 2 -.776987579438799E-03 0.000000000000000E+00 z1= 3 -.126554353487289E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000220)=0.000000000000000E+00 (calc=0.127703411449233E+02 read=0.127703411449233E+02) Weight for this step=-.15622E+00 0.66352E+01 beta (00000221)=0.127703411449233E+02 gamma(00000221)=0.127703411449233E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 221 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000221)=0.000000000000000E+00 (calc=0.132933884841728E+02 read=0.132933884841728E+02) Weight for this step=0.18815E+00 -.61548E+01 beta (00000222)=0.132933884841728E+02 gamma(00000222)=0.132933884841728E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 222 z1= 1 0.872606113910650E-06 0.000000000000000E+00 z1= 2 0.620844232344617E-03 0.000000000000000E+00 z1= 3 0.130815154296470E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000222)=0.000000000000000E+00 (calc=0.128282686446039E+02 read=0.128282686446039E+02) Weight for this step=0.15980E+00 -.66772E+01 beta (00000223)=0.128282686446039E+02 gamma(00000223)=0.128282686446039E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 223 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000223)=0.000000000000000E+00 (calc=0.132058908487242E+02 read=0.132058908487242E+02) Weight for this step=-.18630E+00 0.60372E+01 beta (00000224)=0.132058908487242E+02 gamma(00000224)=0.132058908487242E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 224 z1= 1 -.910036462365912E-06 0.000000000000000E+00 z1= 2 -.430553878533129E-03 0.000000000000000E+00 z1= 3 -.133526239660416E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000224)=0.000000000000000E+00 (calc=0.129770312977519E+02 read=0.129770312977519E+02) Weight for this step=-.16492E+00 0.67855E+01 beta (00000225)=0.129770312977519E+02 gamma(00000225)=0.129770312977519E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 225 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000225)=0.000000000000000E+00 (calc=0.133541700347540E+02 read=0.133541700347540E+02) Weight for this step=0.18074E+00 -.58014E+01 beta (00000226)=0.133541700347540E+02 gamma(00000226)=0.133541700347540E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 226 z1= 1 0.944399509473365E-06 0.000000000000000E+00 z1= 2 0.236409851760667E-03 0.000000000000000E+00 z1= 3 0.137376591355441E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000226)=0.000000000000000E+00 (calc=0.128225225663633E+02 read=0.128225225663633E+02) Weight for this step=0.16956E+00 -.68782E+01 beta (00000227)=0.128225225663633E+02 gamma(00000227)=0.128225225663633E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 227 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000227)=0.000000000000000E+00 (calc=0.135109060216889E+02 read=0.135109060216889E+02) Weight for this step=-.17904E+00 0.56908E+01 beta (00000228)=0.135109060216889E+02 gamma(00000228)=0.135109060216889E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 228 z1= 1 -.953996327546225E-06 0.000000000000000E+00 z1= 2 -.768633584714564E-04 0.000000000000000E+00 z1= 3 -.133799529341186E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000228)=0.000000000000000E+00 (calc=0.127024334944472E+02 read=0.127024334944472E+02) Weight for this step=-.17002E+00 0.68035E+01 beta (00000229)=0.127024334944472E+02 gamma(00000229)=0.127024334944472E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 229 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000229)=0.000000000000000E+00 (calc=0.134491715501510E+02 read=0.134491715501510E+02) Weight for this step=0.18114E+00 -.57024E+01 beta (00000230)=0.134491715501510E+02 gamma(00000230)=0.134491715501510E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 230 z1= 1 0.972377776034539E-06 0.000000000000000E+00 z1= 2 -.455748279973040E-04 0.000000000000000E+00 z1= 3 0.133965330115609E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000230)=0.000000000000000E+00 (calc=0.129123603371113E+02 read=0.129123603371113E+02) Weight for this step=0.16982E+00 -.67033E+01 beta (00000231)=0.129123603371113E+02 gamma(00000231)=0.129123603371113E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 231 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000231)=0.000000000000000E+00 (calc=0.137268104971942E+02 read=0.137268104971942E+02) Weight for this step=-.17954E+00 0.55997E+01 beta (00000232)=0.137268104971942E+02 gamma(00000232)=0.137268104971942E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 232 z1= 1 -.987285613867663E-06 0.000000000000000E+00 z1= 2 0.113504737881565E-03 0.000000000000000E+00 z1= 3 -.130940158504415E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000232)=0.000000000000000E+00 (calc=0.127781174563640E+02 read=0.127781174563640E+02) Weight for this step=-.16871E+00 0.65726E+01 beta (00000233)=0.127781174563640E+02 gamma(00000233)=0.127781174563640E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 233 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000233)=0.000000000000000E+00 (calc=0.133503612623734E+02 read=0.133503612623734E+02) Weight for this step=0.18372E+00 -.56788E+01 beta (00000234)=0.133503612623734E+02 gamma(00000234)=0.133503612623734E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 234 z1= 1 0.100948176495839E-05 0.000000000000000E+00 z1= 2 -.180127206282899E-03 0.000000000000000E+00 z1= 3 0.132116743718742E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000234)=0.000000000000000E+00 (calc=0.125912024451843E+02 read=0.125912024451843E+02) Weight for this step=0.17091E+00 -.65693E+01 beta (00000235)=0.125912024451843E+02 gamma(00000235)=0.125912024451843E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 235 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000235)=0.000000000000000E+00 (calc=0.133931141622375E+02 read=0.133931141622375E+02) Weight for this step=-.18539E+00 0.56796E+01 beta (00000236)=0.133931141622375E+02 gamma(00000236)=0.133931141622375E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 236 z1= 1 -.102199228193406E-05 0.000000000000000E+00 z1= 2 0.213806717262668E-03 0.000000000000000E+00 z1= 3 -.127841568937180E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000236)=0.000000000000000E+00 (calc=0.128915668099101E+02 read=0.128915668099101E+02) Weight for this step=-.17016E+00 0.64535E+01 beta (00000237)=0.128915668099101E+02 gamma(00000237)=0.128915668099101E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 237 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000237)=0.000000000000000E+00 (calc=0.135197304826154E+02 read=0.135197304826154E+02) Weight for this step=0.18346E+00 -.55729E+01 beta (00000238)=0.135197304826154E+02 gamma(00000238)=0.135197304826154E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 238 z1= 1 0.104532951208025E-05 0.000000000000000E+00 z1= 2 -.247530223507467E-03 0.000000000000000E+00 z1= 3 0.127062360820615E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000238)=0.000000000000000E+00 (calc=0.127636396902612E+02 read=0.127636396902612E+02) Weight for this step=0.17155E+00 -.64235E+01 beta (00000239)=0.127636396902612E+02 gamma(00000239)=0.127636396902612E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 239 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000239)=0.000000000000000E+00 (calc=0.133597409977578E+02 read=0.133597409977578E+02) Weight for this step=-.18502E+00 0.55736E+01 beta (00000240)=0.133597409977578E+02 gamma(00000240)=0.133597409977578E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 240 z1= 1 -.108161975349722E-05 0.000000000000000E+00 z1= 2 0.255333974630641E-03 0.000000000000000E+00 z1= 3 -.126380092439678E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000240)=0.000000000000000E+00 (calc=0.127491178290454E+02 read=0.127491178290454E+02) Weight for this step=-.17338E+00 0.64100E+01 beta (00000241)=0.127491178290454E+02 gamma(00000241)=0.127491178290454E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 241 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000241)=0.000000000000000E+00 (calc=0.134029042455223E+02 read=0.134029042455223E+02) Weight for this step=0.18448E+00 -.55115E+01 beta (00000242)=0.134029042455223E+02 gamma(00000242)=0.134029042455223E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 242 z1= 1 0.110527521734105E-05 0.000000000000000E+00 z1= 2 -.217567045153732E-03 0.000000000000000E+00 z1= 3 0.125295766502956E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000242)=0.000000000000000E+00 (calc=0.128892946334448E+02 read=0.128892946334448E+02) Weight for this step=0.17435E+00 -.63665E+01 beta (00000243)=0.128892946334448E+02 gamma(00000243)=0.128892946334448E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 243 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000243)=0.000000000000000E+00 (calc=0.135139866616815E+02 read=0.135139866616815E+02) Weight for this step=-.18248E+00 0.54078E+01 beta (00000244)=0.135139866616815E+02 gamma(00000244)=0.135139866616815E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 244 z1= 1 -.113487958593346E-05 0.000000000000000E+00 z1= 2 0.176696891781706E-03 0.000000000000000E+00 z1= 3 -.123572124250320E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000244)=0.000000000000000E+00 (calc=0.125465536733505E+02 read=0.125465536733505E+02) Weight for this step=-.17553E+00 0.63341E+01 beta (00000245)=0.125465536733505E+02 gamma(00000245)=0.125465536733505E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 245 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000245)=0.000000000000000E+00 (calc=0.130511079468503E+02 read=0.130511079468503E+02) Weight for this step=0.18689E+00 -.54943E+01 beta (00000246)=0.130511079468503E+02 gamma(00000246)=0.130511079468503E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 246 z1= 1 0.118721851062684E-05 0.000000000000000E+00 z1= 2 -.687408421305370E-04 0.000000000000000E+00 z1= 3 0.124278943569936E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000246)=0.000000000000000E+00 (calc=0.125672198386659E+02 read=0.125672198386659E+02) Weight for this step=0.17853E+00 -.63648E+01 beta (00000247)=0.125672198386659E+02 gamma(00000247)=0.125672198386659E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 247 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000247)=0.000000000000000E+00 (calc=0.133322035592173E+02 read=0.133322035592173E+02) Weight for this step=-.18428E+00 0.53743E+01 beta (00000248)=0.133322035592173E+02 gamma(00000248)=0.133322035592173E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 248 z1= 1 -.121480099398059E-05 0.000000000000000E+00 z1= 2 -.265981713172530E-04 0.000000000000000E+00 z1= 3 -.123385205859857E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000248)=0.000000000000000E+00 (calc=0.127880922753763E+02 read=0.127880922753763E+02) Weight for this step=-.17774E+00 0.62634E+01 beta (00000249)=0.127880922753763E+02 gamma(00000249)=0.127880922753763E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 249 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000249)=0.000000000000000E+00 (calc=0.134565568619762E+02 read=0.134565568619762E+02) Weight for this step=0.18253E+00 -.52824E+01 beta (00000250)=0.134565568619762E+02 gamma(00000250)=0.134565568619762E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 250 z1= 1 0.126107430284883E-05 0.000000000000000E+00 z1= 2 0.128723668995353E-03 0.000000000000000E+00 z1= 3 0.122027158859712E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000250)=0.000000000000000E+00 (calc=0.125503639309223E+02 read=0.125503639309223E+02) Weight for this step=0.17818E+00 -.62092E+01 beta (00000251)=0.125503639309223E+02 gamma(00000251)=0.125503639309223E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 251 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000251)=0.000000000000000E+00 (calc=0.132840536605146E+02 read=0.132840536605146E+02) Weight for this step=-.18592E+00 0.53400E+01 beta (00000252)=0.132840536605146E+02 gamma(00000252)=0.132840536605146E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 252 z1= 1 -.129200003281269E-05 0.000000000000000E+00 z1= 2 -.179188200957442E-03 0.000000000000000E+00 z1= 3 -.121041605506209E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000252)=0.000000000000000E+00 (calc=0.129336423167541E+02 read=0.129336423167541E+02) Weight for this step=-.17791E+00 0.61294E+01 beta (00000253)=0.129336423167541E+02 gamma(00000253)=0.129336423167541E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 253 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000253)=0.000000000000000E+00 (calc=0.135149120536037E+02 read=0.135149120536037E+02) Weight for this step=0.18148E+00 -.51744E+01 beta (00000254)=0.135149120536037E+02 gamma(00000254)=0.135149120536037E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 254 z1= 1 0.133250890047357E-05 0.000000000000000E+00 z1= 2 0.150891868853606E-03 0.000000000000000E+00 z1= 3 0.120199219873041E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000254)=0.000000000000000E+00 (calc=0.128019307932415E+02 read=0.128019307932415E+02) Weight for this step=0.17943E+00 -.61164E+01 beta (00000255)=0.128019307932415E+02 gamma(00000255)=0.128019307932415E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 255 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000255)=0.000000000000000E+00 (calc=0.136716697142721E+02 read=0.136716697142721E+02) Weight for this step=-.18194E+00 0.51499E+01 beta (00000256)=0.136716697142721E+02 gamma(00000256)=0.136716697142721E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 256 z1= 1 -.132757292687757E-05 0.000000000000000E+00 z1= 2 -.136956715164454E-03 0.000000000000000E+00 z1= 3 -.118568979223982E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000256)=0.000000000000000E+00 (calc=0.128300179995846E+02 read=0.128300179995846E+02) Weight for this step=-.17710E+00 0.59739E+01 beta (00000257)=0.128300179995846E+02 gamma(00000257)=0.128300179995846E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 257 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000257)=0.000000000000000E+00 (calc=0.134221774427154E+02 read=0.134221774427154E+02) Weight for this step=0.18437E+00 -.51829E+01 beta (00000258)=0.134221774427154E+02 gamma(00000258)=0.134221774427154E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 258 z1= 1 0.134506323670215E-05 0.000000000000000E+00 z1= 2 0.138198170213344E-03 0.000000000000000E+00 z1= 3 0.117713097896936E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000258)=0.000000000000000E+00 (calc=0.130324445508445E+02 read=0.130324445508445E+02) Weight for this step=0.17867E+00 -.59631E+01 beta (00000259)=0.130324445508445E+02 gamma(00000259)=0.130324445508445E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 259 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000259)=0.000000000000000E+00 (calc=0.135340607670088E+02 read=0.135340607670088E+02) Weight for this step=-.18045E+00 0.50384E+01 beta (00000260)=0.135340607670088E+02 gamma(00000260)=0.135340607670088E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 260 z1= 1 -.136541362963892E-05 0.000000000000000E+00 z1= 2 -.927659958290012E-04 0.000000000000000E+00 z1= 3 -.117533193323336E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000260)=0.000000000000000E+00 (calc=0.127717086264339E+02 read=0.127717086264339E+02) Weight for this step=-.18114E+00 0.59857E+01 beta (00000261)=0.127717086264339E+02 gamma(00000261)=0.127717086264339E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 261 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000261)=0.000000000000000E+00 (calc=0.133221274138509E+02 read=0.133221274138509E+02) Weight for this step=0.18147E+00 -.50324E+01 beta (00000262)=0.133221274138509E+02 gamma(00000262)=0.133221274138509E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 262 z1= 1 0.139452693070224E-05 0.000000000000000E+00 z1= 2 0.478562283870339E-04 0.000000000000000E+00 z1= 3 0.114098830172424E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000262)=0.000000000000000E+00 (calc=0.126369388269677E+02 read=0.126369388269677E+02) Weight for this step=0.18295E+00 -.59857E+01 beta (00000263)=0.126369388269677E+02 gamma(00000263)=0.126369388269677E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 263 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000263)=0.000000000000000E+00 (calc=0.132587154934946E+02 read=0.132587154934946E+02) Weight for this step=-.18136E+00 0.49952E+01 beta (00000264)=0.132587154934946E+02 gamma(00000264)=0.132587154934946E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 264 z1= 1 -.141372522817138E-05 0.000000000000000E+00 z1= 2 -.453434143991589E-05 0.000000000000000E+00 z1= 3 -.111464317330547E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000264)=0.000000000000000E+00 (calc=0.127327472975876E+02 read=0.127327472975876E+02) Weight for this step=-.18371E+00 0.59516E+01 beta (00000265)=0.127327472975876E+02 gamma(00000265)=0.127327472975876E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 265 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000265)=0.000000000000000E+00 (calc=0.134480098373093E+02 read=0.134480098373093E+02) Weight for this step=0.17894E+00 -.48956E+01 beta (00000266)=0.134480098373093E+02 gamma(00000266)=0.134480098373093E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 266 z1= 1 0.143363440780787E-05 0.000000000000000E+00 z1= 2 0.646035586818325E-05 0.000000000000000E+00 z1= 3 0.107596559581587E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000266)=0.000000000000000E+00 (calc=0.127991051512289E+02 read=0.127991051512289E+02) Weight for this step=0.18301E+00 -.58733E+01 beta (00000267)=0.127991051512289E+02 gamma(00000267)=0.127991051512289E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 267 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000267)=0.000000000000000E+00 (calc=0.133509673563405E+02 read=0.133509673563405E+02) Weight for this step=-.17819E+00 0.48434E+01 beta (00000268)=0.133509673563405E+02 gamma(00000268)=0.133509673563405E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 268 z1= 1 -.147477075616853E-05 0.000000000000000E+00 z1= 2 -.567036348870821E-04 0.000000000000000E+00 z1= 3 -.105059387456359E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000268)=0.000000000000000E+00 (calc=0.126159938745077E+02 read=0.126159938745077E+02) Weight for this step=-.18454E+00 0.58680E+01 beta (00000269)=0.126159938745077E+02 gamma(00000269)=0.126159938745077E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 269 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000269)=0.000000000000000E+00 (calc=0.135207226860741E+02 read=0.135207226860741E+02) Weight for this step=0.17854E+00 -.48211E+01 beta (00000270)=0.135207226860741E+02 gamma(00000270)=0.135207226860741E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 270 z1= 1 0.147446732578875E-05 0.000000000000000E+00 z1= 2 0.127098384020150E-03 0.000000000000000E+00 z1= 3 0.978920613154729E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000270)=0.000000000000000E+00 (calc=0.130324169214886E+02 read=0.130324169214886E+02) Weight for this step=0.18120E+00 -.57088E+01 beta (00000271)=0.130324169214886E+02 gamma(00000271)=0.130324169214886E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 271 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000271)=0.000000000000000E+00 (calc=0.132956033037527E+02 read=0.132956033037527E+02) Weight for this step=-.17569E+00 0.47150E+01 beta (00000272)=0.132956033037527E+02 gamma(00000272)=0.132956033037527E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 272 z1= 1 -.155406102009779E-05 0.000000000000000E+00 z1= 2 -.191682755721671E-03 0.000000000000000E+00 z1= 3 -.965263491526465E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000272)=0.000000000000000E+00 (calc=0.127269485223252E+02 read=0.127269485223252E+02) Weight for this step=-.18661E+00 0.58279E+01 beta (00000273)=0.127269485223252E+02 gamma(00000273)=0.127269485223252E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 273 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000273)=0.000000000000000E+00 (calc=0.134985187746427E+02 read=0.134985187746427E+02) Weight for this step=0.17348E+00 -.46260E+01 beta (00000274)=0.134985187746427E+02 gamma(00000274)=0.134985187746427E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 274 z1= 1 0.157806974653008E-05 0.000000000000000E+00 z1= 2 0.170281401654718E-03 0.000000000000000E+00 z1= 3 0.892795715572213E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000274)=0.000000000000000E+00 (calc=0.128622195341415E+02 read=0.128622195341415E+02) Weight for this step=0.18470E+00 -.57191E+01 beta (00000275)=0.128622195341415E+02 gamma(00000275)=0.128622195341415E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 275 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000275)=0.000000000000000E+00 (calc=0.137440404561413E+02 read=0.137440404561413E+02) Weight for this step=-.17222E+00 0.45638E+01 beta (00000276)=0.137440404561413E+02 gamma(00000276)=0.137440404561413E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 276 z1= 1 -.157822361084373E-05 0.000000000000000E+00 z1= 2 -.142696395629180E-03 0.000000000000000E+00 z1= 3 -.823101514791150E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000276)=0.000000000000000E+00 (calc=0.127464610376212E+02 read=0.127464610376212E+02) Weight for this step=-.18139E+00 0.55695E+01 beta (00000277)=0.127464610376212E+02 gamma(00000277)=0.127464610376212E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 277 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000277)=0.000000000000000E+00 (calc=0.131863605069894E+02 read=0.131863605069894E+02) Weight for this step=0.17594E+00 -.46349E+01 beta (00000278)=0.131863605069894E+02 gamma(00000278)=0.131863605069894E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 278 z1= 1 0.163462003272691E-05 0.000000000000000E+00 z1= 2 0.109513420053133E-03 0.000000000000000E+00 z1= 3 0.771098534453542E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000278)=0.000000000000000E+00 (calc=0.125348490709038E+02 read=0.125348490709038E+02) Weight for this step=0.18442E+00 -.56138E+01 beta (00000279)=0.125348490709038E+02 gamma(00000279)=0.125348490709038E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 279 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000279)=0.000000000000000E+00 (calc=0.133613109230864E+02 read=0.133613109230864E+02) Weight for this step=-.17501E+00 0.45827E+01 beta (00000280)=0.133613109230864E+02 gamma(00000280)=0.133613109230864E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 280 z1= 1 -.163670117016637E-05 0.000000000000000E+00 z1= 2 -.759403689261102E-04 0.000000000000000E+00 z1= 3 -.703836548087051E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000280)=0.000000000000000E+00 (calc=0.128734600323008E+02 read=0.128734600323008E+02) Weight for this step=-.18193E+00 0.54910E+01 beta (00000281)=0.128734600323008E+02 gamma(00000281)=0.128734600323008E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 281 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000281)=0.000000000000000E+00 (calc=0.132961402939048E+02 read=0.132961402939048E+02) Weight for this step=0.17196E+00 -.44772E+01 beta (00000282)=0.132961402939048E+02 gamma(00000282)=0.132961402939048E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 282 z1= 1 0.168079154288202E-05 0.000000000000000E+00 z1= 2 0.275906530979196E-04 0.000000000000000E+00 z1= 3 0.647156618064975E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000282)=0.000000000000000E+00 (calc=0.125942929899832E+02 read=0.125942929899832E+02) Weight for this step=0.18495E+00 -.55369E+01 beta (00000283)=0.125942929899832E+02 gamma(00000283)=0.125942929899832E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 283 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000283)=0.000000000000000E+00 (calc=0.132143407751469E+02 read=0.132143407751469E+02) Weight for this step=-.17149E+00 0.44389E+01 beta (00000284)=0.132143407751469E+02 gamma(00000284)=0.132143407751469E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 284 z1= 1 -.169448906673329E-05 0.000000000000000E+00 z1= 2 0.583852729084218E-04 0.000000000000000E+00 z1= 3 -.574042646509139E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000284)=0.000000000000000E+00 (calc=0.126628073134760E+02 read=0.126628073134760E+02) Weight for this step=-.18510E+00 0.54970E+01 beta (00000285)=0.126628073134760E+02 gamma(00000285)=0.126628073134760E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 285 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000285)=0.000000000000000E+00 (calc=0.134122137893592E+02 read=0.134122137893592E+02) Weight for this step=0.16896E+00 -.43481E+01 beta (00000286)=0.134122137893592E+02 gamma(00000286)=0.134122137893592E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 286 z1= 1 0.168271216367116E-05 0.000000000000000E+00 z1= 2 -.190995220040017E-03 0.000000000000000E+00 z1= 3 0.504200556868388E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000286)=0.000000000000000E+00 (calc=0.126240008132624E+02 read=0.126240008132624E+02) Weight for this step=0.18333E+00 -.54020E+01 beta (00000287)=0.126240008132624E+02 gamma(00000287)=0.126240008132624E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 287 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000287)=0.000000000000000E+00 (calc=0.130876656076923E+02 read=0.130876656076923E+02) Weight for this step=-.16958E+00 0.43395E+01 beta (00000288)=0.130876656076923E+02 gamma(00000288)=0.130876656076923E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 288 z1= 1 -.171015535151055E-05 0.000000000000000E+00 z1= 2 0.349756716119525E-03 0.000000000000000E+00 z1= 3 -.414278006011671E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000288)=0.000000000000000E+00 (calc=0.127646911703897E+02 read=0.127646911703897E+02) Weight for this step=-.18565E+00 0.54277E+01 beta (00000289)=0.127646911703897E+02 gamma(00000289)=0.127646911703897E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 289 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000289)=0.000000000000000E+00 (calc=0.134266750564664E+02 read=0.134266750564664E+02) Weight for this step=0.16392E+00 -.41709E+01 beta (00000290)=0.134266750564664E+02 gamma(00000290)=0.134266750564664E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 290 z1= 1 0.170229660603587E-05 0.000000000000000E+00 z1= 2 -.501289372105538E-03 0.000000000000000E+00 z1= 3 0.344846806925791E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000290)=0.000000000000000E+00 (calc=0.127607117392204E+02 read=0.127607117392204E+02) Weight for this step=0.18480E+00 -.53634E+01 beta (00000291)=0.127607117392204E+02 gamma(00000291)=0.127607117392204E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 291 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000291)=0.000000000000000E+00 (calc=0.131977186799303E+02 read=0.131977186799303E+02) Weight for this step=-.16257E+00 0.41135E+01 beta (00000292)=0.131977186799303E+02 gamma(00000292)=0.131977186799303E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 292 z1= 1 -.172943583259203E-05 0.000000000000000E+00 z1= 2 0.625416105519390E-03 0.000000000000000E+00 z1= 3 -.251729362575891E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000292)=0.000000000000000E+00 (calc=0.126412198962739E+02 read=0.126412198962739E+02) Weight for this step=-.18705E+00 0.53898E+01 beta (00000293)=0.126412198962739E+02 gamma(00000293)=0.126412198962739E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 293 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000293)=0.000000000000000E+00 (calc=0.135269357693572E+02 read=0.135269357693572E+02) Weight for this step=0.15962E+00 -.40155E+01 beta (00000294)=0.135269357693572E+02 gamma(00000294)=0.135269357693572E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 294 z1= 1 0.167999638988735E-05 0.000000000000000E+00 z1= 2 -.725936229533813E-03 0.000000000000000E+00 z1= 3 0.198791221524877E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000294)=0.000000000000000E+00 (calc=0.129785112100049E+02 read=0.129785112100049E+02) Weight for this step=0.18283E+00 -.52312E+01 beta (00000295)=0.129785112100049E+02 gamma(00000295)=0.129785112100049E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 295 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000295)=0.000000000000000E+00 (calc=0.135622829076972E+02 read=0.135622829076972E+02) Weight for this step=-.15674E+00 0.39213E+01 beta (00000296)=0.135622829076972E+02 gamma(00000296)=0.135622829076972E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 296 z1= 1 -.168504424678893E-05 0.000000000000000E+00 z1= 2 0.768704596292417E-03 0.000000000000000E+00 z1= 3 -.129597021937230E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000296)=0.000000000000000E+00 (calc=0.127907392600332E+02 read=0.127907392600332E+02) Weight for this step=-.18281E+00 0.51953E+01 beta (00000297)=0.127907392600332E+02 gamma(00000297)=0.127907392600332E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 297 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000297)=0.000000000000000E+00 (calc=0.133436976241761E+02 read=0.133436976241761E+02) Weight for this step=0.15643E+00 -.38920E+01 beta (00000298)=0.133436976241761E+02 gamma(00000298)=0.133436976241761E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 298 z1= 1 0.167961549451656E-05 0.000000000000000E+00 z1= 2 -.707544265171190E-03 0.000000000000000E+00 z1= 3 0.910713718204779E-07 0.000000000000000E+00 Calculating total response charge density alpha(00000298)=0.000000000000000E+00 (calc=0.130107145637696E+02 read=0.130107145637696E+02) Weight for this step=0.18320E+00 -.51709E+01 beta (00000299)=0.130107145637696E+02 gamma(00000299)=0.130107145637696E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 299 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000299)=0.000000000000000E+00 (calc=0.136889156185896E+02 read=0.136889156185896E+02) Weight for this step=-.15082E+00 0.37315E+01 beta (00000300)=0.136889156185896E+02 gamma(00000300)=0.136889156185896E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 300 z1= 1 -.167450681560696E-05 0.000000000000000E+00 z1= 2 0.684645446394782E-03 0.000000000000000E+00 z1= 3 -.325547169062685E-07 0.000000000000000E+00 Calculating total response charge density alpha(00000300)=0.000000000000000E+00 (calc=0.127325773352904E+02 read=0.127325773352904E+02) Weight for this step=-.18161E+00 0.50932E+01 beta (00000301)=0.127325773352904E+02 gamma(00000301)=0.127325773352904E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 301 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000301)=0.000000000000000E+00 (calc=0.132014487848504E+02 read=0.132014487848504E+02) Weight for this step=0.15241E+00 -.37499E+01 beta (00000302)=0.132014487848504E+02 gamma(00000302)=0.132014487848504E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 302 z1= 1 0.168245889043111E-05 0.000000000000000E+00 z1= 2 -.647272898753966E-03 0.000000000000000E+00 z1= 3 0.755107433796521E-08 0.000000000000000E+00 Calculating total response charge density alpha(00000302)=0.000000000000000E+00 (calc=0.127870309133300E+02 read=0.127870309133300E+02) Weight for this step=0.18300E+00 -.50982E+01 beta (00000303)=0.127870309133300E+02 gamma(00000303)=0.127870309133300E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 303 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000303)=0.000000000000000E+00 (calc=0.135647531490717E+02 read=0.135647531490717E+02) Weight for this step=-.14759E+00 0.36104E+01 beta (00000304)=0.135647531490717E+02 gamma(00000304)=0.135647531490717E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 304 z1= 1 -.166716901492522E-05 0.000000000000000E+00 z1= 2 0.551175315352377E-03 0.000000000000000E+00 z1= 3 0.176471976389564E-07 0.000000000000000E+00 Calculating total response charge density alpha(00000304)=0.000000000000000E+00 (calc=0.128308750491585E+02 read=0.128308750491585E+02) Weight for this step=-.17990E+00 0.49801E+01 beta (00000305)=0.128308750491585E+02 gamma(00000305)=0.128308750491585E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 305 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000305)=0.000000000000000E+00 (calc=0.134495308588633E+02 read=0.134495308588633E+02) Weight for this step=0.14646E+00 -.35629E+01 beta (00000306)=0.134495308588633E+02 gamma(00000306)=0.134495308588633E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 306 z1= 1 0.167531826631134E-05 0.000000000000000E+00 z1= 2 -.426463914298500E-03 0.000000000000000E+00 z1= 3 -.394053602761793E-07 0.000000000000000E+00 Calculating total response charge density alpha(00000306)=0.000000000000000E+00 (calc=0.127987513860681E+02 read=0.127987513860681E+02) Weight for this step=0.17902E+00 -.49244E+01 beta (00000307)=0.127987513860681E+02 gamma(00000307)=0.127987513860681E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 307 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000307)=0.000000000000000E+00 (calc=0.135696261752637E+02 read=0.135696261752637E+02) Weight for this step=-.14437E+00 0.34922E+01 beta (00000308)=0.135696261752637E+02 gamma(00000308)=0.135696261752637E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 308 z1= 1 -.166929078432212E-05 0.000000000000000E+00 z1= 2 0.239660955568350E-03 0.000000000000000E+00 z1= 3 0.675470303518680E-07 0.000000000000000E+00 Calculating total response charge density alpha(00000308)=0.000000000000000E+00 (calc=0.127885413404553E+02 read=0.127885413404553E+02) Weight for this step=-.17607E+00 0.48131E+01 beta (00000309)=0.127885413404553E+02 gamma(00000309)=0.127885413404553E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 309 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000309)=0.000000000000000E+00 (calc=0.133077694844220E+02 read=0.133077694844220E+02) Weight for this step=0.14380E+00 -.34591E+01 beta (00000310)=0.133077694844220E+02 gamma(00000310)=0.133077694844220E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 310 z1= 1 0.168443650944584E-05 0.000000000000000E+00 z1= 2 -.705070220550124E-04 0.000000000000000E+00 z1= 3 -.111919997692733E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000310)=0.000000000000000E+00 (calc=0.127286681926412E+02 read=0.127286681926412E+02) Weight for this step=0.17653E+00 -.47955E+01 beta (00000311)=0.127286681926412E+02 gamma(00000311)=0.127286681926412E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 311 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000311)=0.000000000000000E+00 (calc=0.134430681708486E+02 read=0.134430681708486E+02) Weight for this step=-.14088E+00 0.33699E+01 beta (00000312)=0.134430681708486E+02 gamma(00000312)=0.134430681708486E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 312 z1= 1 -.168672394563031E-05 0.000000000000000E+00 z1= 2 -.739757141366730E-04 0.000000000000000E+00 z1= 3 0.136203964960129E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000312)=0.000000000000000E+00 (calc=0.128578436259766E+02 read=0.128578436259766E+02) Weight for this step=-.17426E+00 0.47047E+01 beta (00000313)=0.128578436259766E+02 gamma(00000313)=0.128578436259766E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 313 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000313)=0.000000000000000E+00 (calc=0.132261688765880E+02 read=0.132261688765880E+02) Weight for this step=0.13806E+00 -.32838E+01 beta (00000314)=0.132261688765880E+02 gamma(00000314)=0.132261688765880E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 314 z1= 1 0.174613556417377E-05 0.000000000000000E+00 z1= 2 0.259139317874287E-03 0.000000000000000E+00 z1= 3 -.152148177303443E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000314)=0.000000000000000E+00 (calc=0.124474649642795E+02 read=0.124474649642795E+02) Weight for this step=0.17649E+00 -.47362E+01 beta (00000315)=0.124474649642795E+02 gamma(00000315)=0.124474649642795E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 315 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000315)=0.000000000000000E+00 (calc=0.134572311191633E+02 read=0.134572311191633E+02) Weight for this step=-.13703E+00 0.32402E+01 beta (00000316)=0.134572311191633E+02 gamma(00000316)=0.134572311191633E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 316 z1= 1 -.172060932114603E-05 0.000000000000000E+00 z1= 2 -.404046364644721E-03 0.000000000000000E+00 z1= 3 0.114035490731725E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000316)=0.000000000000000E+00 (calc=0.125627924292246E+02 read=0.125627924292246E+02) Weight for this step=-.17015E+00 0.45384E+01 beta (00000317)=0.125627924292246E+02 gamma(00000317)=0.125627924292246E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 317 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000317)=0.000000000000000E+00 (calc=0.134454999593869E+02 read=0.134454999593869E+02) Weight for this step=0.13756E+00 -.32344E+01 beta (00000318)=0.134454999593869E+02 gamma(00000318)=0.134454999593869E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 318 z1= 1 0.171096878992354E-05 0.000000000000000E+00 z1= 2 0.507490277590244E-03 0.000000000000000E+00 z1= 3 -.121091880290764E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000318)=0.000000000000000E+00 (calc=0.125691258390293E+02 read=0.125691258390293E+02) Weight for this step=0.16592E+00 -.43980E+01 beta (00000319)=0.125691258390293E+02 gamma(00000319)=0.125691258390293E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 319 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000319)=0.000000000000000E+00 (calc=0.132683743555628E+02 read=0.132683743555628E+02) Weight for this step=-.13816E+00 0.32309E+01 beta (00000320)=0.132683743555628E+02 gamma(00000320)=0.132683743555628E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 320 z1= 1 -.173510962716682E-05 0.000000000000000E+00 z1= 2 -.613741246854104E-03 0.000000000000000E+00 z1= 3 0.824301510115883E-07 0.000000000000000E+00 Calculating total response charge density alpha(00000320)=0.000000000000000E+00 (calc=0.128768098339927E+02 read=0.128768098339927E+02) Weight for this step=-.16424E+00 0.43256E+01 beta (00000321)=0.128768098339927E+02 gamma(00000321)=0.128768098339927E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 321 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000321)=0.000000000000000E+00 (calc=0.135396602572877E+02 read=0.135396602572877E+02) Weight for this step=0.13368E+00 -.31092E+01 beta (00000322)=0.135396602572877E+02 gamma(00000322)=0.135396602572877E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 322 z1= 1 0.178309204377277E-05 0.000000000000000E+00 z1= 2 0.611567668819772E-03 0.000000000000000E+00 z1= 3 -.682260537335526E-07 0.000000000000000E+00 Calculating total response charge density alpha(00000322)=0.000000000000000E+00 (calc=0.127480241353615E+02 read=0.127480241353615E+02) Weight for this step=0.16289E+00 -.42641E+01 beta (00000323)=0.127480241353615E+02 gamma(00000323)=0.127480241353615E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 323 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000323)=0.000000000000000E+00 (calc=0.132686652253103E+02 read=0.132686652253103E+02) Weight for this step=-.13328E+00 0.30834E+01 beta (00000324)=0.132686652253103E+02 gamma(00000324)=0.132686652253103E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 324 z1= 1 -.183059107428194E-05 0.000000000000000E+00 z1= 2 -.593337003143229E-03 0.000000000000000E+00 z1= 3 0.229762592052793E-07 0.000000000000000E+00 Calculating total response charge density alpha(00000324)=0.000000000000000E+00 (calc=0.127942827515080E+02 read=0.127942827515080E+02) Weight for this step=-.16330E+00 0.42489E+01 beta (00000325)=0.127942827515080E+02 gamma(00000325)=0.127942827515080E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 325 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000325)=0.000000000000000E+00 (calc=0.137027001426078E+02 read=0.137027001426078E+02) Weight for this step=0.12953E+00 -.29803E+01 beta (00000326)=0.137027001426078E+02 gamma(00000326)=0.137027001426078E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 326 z1= 1 0.183481642014680E-05 0.000000000000000E+00 z1= 2 0.515227588434150E-03 0.000000000000000E+00 z1= 3 -.421668392662088E-07 0.000000000000000E+00 Calculating total response charge density alpha(00000326)=0.000000000000000E+00 (calc=0.126562924908262E+02 read=0.126562924908262E+02) Weight for this step=0.15888E+00 -.41096E+01 beta (00000327)=0.126562924908262E+02 gamma(00000327)=0.126562924908262E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 327 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000327)=0.000000000000000E+00 (calc=0.132710951464007E+02 read=0.132710951464007E+02) Weight for this step=-.13170E+00 0.30142E+01 beta (00000328)=0.132710951464007E+02 gamma(00000328)=0.132710951464007E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 328 z1= 1 -.186609580259556E-05 0.000000000000000E+00 z1= 2 -.372280021037917E-03 0.000000000000000E+00 z1= 3 0.788269774215818E-09 0.000000000000000E+00 Calculating total response charge density alpha(00000328)=0.000000000000000E+00 (calc=0.128093971320915E+02 read=0.128093971320915E+02) Weight for this step=-.15825E+00 0.40679E+01 beta (00000329)=0.128093971320915E+02 gamma(00000329)=0.128093971320915E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 329 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000329)=0.000000000000000E+00 (calc=0.136222209864970E+02 read=0.136222209864970E+02) Weight for this step=0.12804E+00 -.29150E+01 beta (00000330)=0.136222209864970E+02 gamma(00000330)=0.136222209864970E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 330 z1= 1 0.188768260157802E-05 0.000000000000000E+00 z1= 2 0.204261523050335E-03 0.000000000000000E+00 z1= 3 -.616045428256421E-08 0.000000000000000E+00 Calculating total response charge density alpha(00000330)=0.000000000000000E+00 (calc=0.126670241263200E+02 read=0.126670241263200E+02) Weight for this step=0.15517E+00 -.39652E+01 beta (00000331)=0.126670241263200E+02 gamma(00000331)=0.126670241263200E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 331 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000331)=0.000000000000000E+00 (calc=0.133665205684371E+02 read=0.133665205684371E+02) Weight for this step=-.12937E+00 0.29299E+01 beta (00000332)=0.133665205684371E+02 gamma(00000332)=0.133665205684371E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 332 z1= 1 -.191076385247686E-05 0.000000000000000E+00 z1= 2 0.521321095403419E-05 0.000000000000000E+00 z1= 3 -.369587469134817E-07 0.000000000000000E+00 Calculating total response charge density alpha(00000332)=0.000000000000000E+00 (calc=0.128362196975157E+02 read=0.128362196975157E+02) Weight for this step=-.15361E+00 0.39012E+01 beta (00000333)=0.128362196975157E+02 gamma(00000333)=0.128362196975157E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 333 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000333)=0.000000000000000E+00 (calc=0.134610345081187E+02 read=0.134610345081187E+02) Weight for this step=0.12658E+00 -.28520E+01 beta (00000334)=0.134610345081187E+02 gamma(00000334)=0.134610345081187E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 334 z1= 1 0.196740617152118E-05 0.000000000000000E+00 z1= 2 -.149667990688938E-03 0.000000000000000E+00 z1= 3 0.390289648726460E-07 0.000000000000000E+00 Calculating total response charge density alpha(00000334)=0.000000000000000E+00 (calc=0.124678181602357E+02 read=0.124678181602357E+02) Weight for this step=0.15284E+00 -.38588E+01 beta (00000335)=0.124678181602357E+02 gamma(00000335)=0.124678181602357E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 335 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000335)=0.000000000000000E+00 (calc=0.130935907161810E+02 read=0.130935907161810E+02) Weight for this step=-.12832E+00 0.28766E+01 beta (00000336)=0.130935907161810E+02 gamma(00000336)=0.130935907161810E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 336 z1= 1 -.201214556908979E-05 0.000000000000000E+00 z1= 2 0.268242964186641E-03 0.000000000000000E+00 z1= 3 -.107704328202563E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000336)=0.000000000000000E+00 (calc=0.129076750594721E+02 read=0.129076750594721E+02) Weight for this step=-.15217E+00 0.38182E+01 beta (00000337)=0.129076750594721E+02 gamma(00000337)=0.129076750594721E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 337 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000337)=0.000000000000000E+00 (calc=0.135012873479254E+02 read=0.135012873479254E+02) Weight for this step=0.12216E+00 -.27244E+01 beta (00000338)=0.135012873479254E+02 gamma(00000338)=0.135012873479254E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 338 z1= 1 0.207656199710006E-05 0.000000000000000E+00 z1= 2 -.430242704326196E-03 0.000000000000000E+00 z1= 3 0.125180376712715E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000338)=0.000000000000000E+00 (calc=0.126384590763615E+02 read=0.126384590763615E+02) Weight for this step=0.15161E+00 -.37824E+01 beta (00000339)=0.126384590763615E+02 gamma(00000339)=0.126384590763615E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 339 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000339)=0.000000000000000E+00 (calc=0.132422079861262E+02 read=0.132422079861262E+02) Weight for this step=-.12235E+00 0.27145E+01 beta (00000340)=0.132422079861262E+02 gamma(00000340)=0.132422079861262E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 340 z1= 1 -.212818595083427E-05 0.000000000000000E+00 z1= 2 0.595769954586347E-03 0.000000000000000E+00 z1= 3 -.184999855043348E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000340)=0.000000000000000E+00 (calc=0.126707129061398E+02 read=0.126707129061398E+02) Weight for this step=-.15095E+00 0.37441E+01 beta (00000341)=0.126707129061398E+02 gamma(00000341)=0.126707129061398E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 341 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000341)=0.000000000000000E+00 (calc=0.136753605969909E+02 read=0.136753605969909E+02) Weight for this step=0.11977E+00 -.26435E+01 beta (00000342)=0.136753605969909E+02 gamma(00000342)=0.136753605969909E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 342 z1= 1 0.211864933039301E-05 0.000000000000000E+00 z1= 2 -.712254604936116E-03 0.000000000000000E+00 z1= 3 0.178232005117765E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000342)=0.000000000000000E+00 (calc=0.127943552503819E+02 read=0.127943552503819E+02) Weight for this step=0.14579E+00 -.35956E+01 beta (00000343)=0.127943552503819E+02 gamma(00000343)=0.127943552503819E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 343 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000343)=0.000000000000000E+00 (calc=0.135431231585370E+02 read=0.135431231585370E+02) Weight for this step=-.12028E+00 0.26416E+01 beta (00000344)=0.135431231585370E+02 gamma(00000344)=0.135431231585370E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 344 z1= 1 -.212355215422049E-05 0.000000000000000E+00 z1= 2 0.857918071920317E-03 0.000000000000000E+00 z1= 3 -.216152375186293E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000344)=0.000000000000000E+00 (calc=0.129527963646180E+02 read=0.129527963646180E+02) Weight for this step=-.14373E+00 0.35245E+01 beta (00000345)=0.129527963646180E+02 gamma(00000345)=0.129527963646180E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 345 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000345)=0.000000000000000E+00 (calc=0.134551263461387E+02 read=0.134551263461387E+02) Weight for this step=0.11823E+00 -.25839E+01 beta (00000346)=0.134551263461387E+02 gamma(00000346)=0.134551263461387E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 346 z1= 1 0.220132946146534E-05 0.000000000000000E+00 z1= 2 -.104511270130339E-02 0.000000000000000E+00 z1= 3 0.223251783271845E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000346)=0.000000000000000E+00 (calc=0.125651941790397E+02 read=0.125651941790397E+02) Weight for this step=0.14431E+00 -.35186E+01 beta (00000347)=0.125651941790397E+02 gamma(00000347)=0.125651941790397E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 347 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000347)=0.000000000000000E+00 (calc=0.134783867418469E+02 read=0.134783867418469E+02) Weight for this step=-.11880E+00 0.25836E+01 beta (00000348)=0.134783867418469E+02 gamma(00000348)=0.134783867418469E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 348 z1= 1 -.219130057782860E-05 0.000000000000000E+00 z1= 2 0.116944914391981E-02 0.000000000000000E+00 z1= 3 -.258590269266675E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000348)=0.000000000000000E+00 (calc=0.129739928957293E+02 read=0.129739928957293E+02) Weight for this step=-.14050E+00 0.34056E+01 beta (00000349)=0.129739928957293E+02 gamma(00000349)=0.129739928957293E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 349 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000349)=0.000000000000000E+00 (calc=0.134297684082514E+02 read=0.134297684082514E+02) Weight for this step=0.11607E+00 -.25122E+01 beta (00000350)=0.134297684082514E+02 gamma(00000350)=0.134297684082514E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 350 z1= 1 0.225622133388781E-05 0.000000000000000E+00 z1= 2 -.135349710401532E-02 0.000000000000000E+00 z1= 3 0.256690869032900E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000350)=0.000000000000000E+00 (calc=0.125508355125286E+02 read=0.125508355125286E+02) Weight for this step=0.14157E+00 -.34125E+01 beta (00000351)=0.125508355125286E+02 gamma(00000351)=0.125508355125286E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 351 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000351)=0.000000000000000E+00 (calc=0.134338435878174E+02 read=0.134338435878174E+02) Weight for this step=-.11654E+00 0.25102E+01 beta (00000352)=0.134338435878174E+02 gamma(00000352)=0.134338435878174E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 352 z1= 1 -.223607626077989E-05 0.000000000000000E+00 z1= 2 0.143555684430277E-02 0.000000000000000E+00 z1= 3 -.266258456721100E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000352)=0.000000000000000E+00 (calc=0.129530910448955E+02 read=0.129530910448955E+02) Weight for this step=-.13813E+00 0.33105E+01 beta (00000353)=0.129530910448955E+02 gamma(00000353)=0.129530910448955E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 353 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000353)=0.000000000000000E+00 (calc=0.132873602007166E+02 read=0.132873602007166E+02) Weight for this step=0.11363E+00 -.24361E+01 beta (00000354)=0.132873602007166E+02 gamma(00000354)=0.132873602007166E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 354 z1= 1 0.233853340717016E-05 0.000000000000000E+00 z1= 2 -.157566180946363E-02 0.000000000000000E+00 z1= 3 0.265867415534093E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000354)=0.000000000000000E+00 (calc=0.124749176641733E+02 read=0.124749176641733E+02) Weight for this step=0.14044E+00 -.33472E+01 beta (00000355)=0.124749176641733E+02 gamma(00000355)=0.124749176641733E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 355 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000355)=0.000000000000000E+00 (calc=0.136129860611111E+02 read=0.136129860611111E+02) Weight for this step=-.11339E+00 0.24191E+01 beta (00000356)=0.136129860611111E+02 gamma(00000356)=0.136129860611111E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 356 z1= 1 -.227876627792445E-05 0.000000000000000E+00 z1= 2 0.166796377892423E-02 0.000000000000000E+00 z1= 3 -.263219235247382E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000356)=0.000000000000000E+00 (calc=0.128740530104588E+02 read=0.128740530104588E+02) Weight for this step=-.13433E+00 0.31837E+01 beta (00000357)=0.128740530104588E+02 gamma(00000357)=0.128740530104588E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 357 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000357)=0.000000000000000E+00 (calc=0.136854147256959E+02 read=0.136854147256959E+02) Weight for this step=0.11282E+00 -.23961E+01 beta (00000358)=0.136854147256959E+02 gamma(00000358)=0.136854147256959E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 358 z1= 1 0.230670364926612E-05 0.000000000000000E+00 z1= 2 -.178720334654294E-02 0.000000000000000E+00 z1= 3 0.261888233401669E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000358)=0.000000000000000E+00 (calc=0.126594224871377E+02 read=0.126594224871377E+02) Weight for this step=0.13194E+00 -.31096E+01 beta (00000359)=0.126594224871377E+02 gamma(00000359)=0.126594224871377E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 359 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000359)=0.000000000000000E+00 (calc=0.138515722109383E+02 read=0.138515722109383E+02) Weight for this step=-.11490E+00 0.24295E+01 beta (00000360)=0.138515722109383E+02 gamma(00000360)=0.138515722109383E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 360 z1= 1 -.227569845869750E-05 0.000000000000000E+00 z1= 2 0.183607400319989E-02 0.000000000000000E+00 z1= 3 -.248016316406154E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000360)=0.000000000000000E+00 (calc=0.124128294396756E+02 read=0.124128294396756E+02) Weight for this step=-.12619E+00 0.29567E+01 beta (00000361)=0.124128294396756E+02 gamma(00000361)=0.124128294396756E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 361 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000361)=0.000000000000000E+00 (calc=0.134327987811526E+02 read=0.134327987811526E+02) Weight for this step=0.12133E+00 -.25551E+01 beta (00000362)=0.134327987811526E+02 gamma(00000362)=0.134327987811526E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 362 z1= 1 0.230707949244301E-05 0.000000000000000E+00 z1= 2 -.191584878387537E-02 0.000000000000000E+00 z1= 3 0.262247996275552E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000362)=0.000000000000000E+00 (calc=0.128797661687270E+02 read=0.128797661687270E+02) Weight for this step=0.12271E+00 -.28567E+01 beta (00000363)=0.128797661687270E+02 gamma(00000363)=0.128797661687270E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 363 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000363)=0.000000000000000E+00 (calc=0.135103422048673E+02 read=0.135103422048673E+02) Weight for this step=-.12008E+00 0.25197E+01 beta (00000364)=0.135103422048673E+02 gamma(00000364)=0.135103422048673E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 364 z1= 1 -.240656608974273E-05 0.000000000000000E+00 z1= 2 0.201944678404543E-02 0.000000000000000E+00 z1= 3 -.247077090699384E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000364)=0.000000000000000E+00 (calc=0.122994636981778E+02 read=0.122994636981778E+02) Weight for this step=-.12298E+00 0.28455E+01 beta (00000365)=0.122994636981778E+02 gamma(00000365)=0.122994636981778E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 365 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000365)=0.000000000000000E+00 (calc=0.129062913945586E+02 read=0.129062913945586E+02) Weight for this step=0.12512E+00 -.26163E+01 beta (00000366)=0.129062913945586E+02 gamma(00000366)=0.129062913945586E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 366 z1= 1 0.252453145578937E-05 0.000000000000000E+00 z1= 2 -.211652331959299E-02 0.000000000000000E+00 z1= 3 0.272786362234226E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000366)=0.000000000000000E+00 (calc=0.127034680757071E+02 read=0.127034680757071E+02) Weight for this step=0.12375E+00 -.28444E+01 beta (00000367)=0.127034680757071E+02 gamma(00000367)=0.127034680757071E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 367 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000367)=0.000000000000000E+00 (calc=0.134767166076625E+02 read=0.134767166076625E+02) Weight for this step=-.12052E+00 0.25115E+01 beta (00000368)=0.134767166076625E+02 gamma(00000368)=0.134767166076625E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 368 z1= 1 -.259678725443840E-05 0.000000000000000E+00 z1= 2 0.215018172107982E-02 0.000000000000000E+00 z1= 3 -.231482439604547E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000368)=0.000000000000000E+00 (calc=0.125626721130143E+02 read=0.125626721130143E+02) Weight for this step=-.12269E+00 0.28032E+01 beta (00000369)=0.125626721130143E+02 gamma(00000369)=0.125626721130143E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 369 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000369)=0.000000000000000E+00 (calc=0.133692926302659E+02 read=0.133692926302659E+02) Weight for this step=0.12267E+00 -.25482E+01 beta (00000370)=0.133692926302659E+02 gamma(00000370)=0.133692926302659E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 370 z1= 1 0.264599542601322E-05 0.000000000000000E+00 z1= 2 -.212542108382922E-02 0.000000000000000E+00 z1= 3 0.249756781202772E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000370)=0.000000000000000E+00 (calc=0.128827401390957E+02 read=0.128827401390957E+02) Weight for this step=0.12149E+00 -.27588E+01 beta (00000371)=0.128827401390957E+02 gamma(00000371)=0.128827401390957E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 371 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000371)=0.000000000000000E+00 (calc=0.133106920710818E+02 read=0.133106920710818E+02) Weight for this step=-.12092E+00 0.25043E+01 beta (00000372)=0.133106920710818E+02 gamma(00000372)=0.133106920710818E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 372 z1= 1 -.278183490293529E-05 0.000000000000000E+00 z1= 2 0.214723595642328E-02 0.000000000000000E+00 z1= 3 -.187988392705263E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000372)=0.000000000000000E+00 (calc=0.128999364065571E+02 read=0.128999364065571E+02) Weight for this step=-.12371E+00 0.27932E+01 beta (00000373)=0.128999364065571E+02 gamma(00000373)=0.128999364065571E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 373 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000373)=0.000000000000000E+00 (calc=0.136448690011519E+02 read=0.136448690011519E+02) Weight for this step=0.11827E+00 -.24423E+01 beta (00000374)=0.136448690011519E+02 gamma(00000374)=0.136448690011519E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 374 z1= 1 0.283231471173272E-05 0.000000000000000E+00 z1= 2 -.207157533018765E-02 0.000000000000000E+00 z1= 3 0.217953873970101E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000374)=0.000000000000000E+00 (calc=0.128456592932389E+02 read=0.128456592932389E+02) Weight for this step=0.12281E+00 -.27579E+01 beta (00000375)=0.128456592932389E+02 gamma(00000375)=0.128456592932389E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 375 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000375)=0.000000000000000E+00 (calc=0.131827349382898E+02 read=0.131827349382898E+02) Weight for this step=-.11916E+00 0.24537E+01 beta (00000376)=0.131827349382898E+02 gamma(00000376)=0.131827349382898E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 376 z1= 1 -.299477888095201E-05 0.000000000000000E+00 z1= 2 0.196862133418563E-02 0.000000000000000E+00 z1= 3 -.143923398642030E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000376)=0.000000000000000E+00 (calc=0.130315379073753E+02 read=0.130315379073753E+02) Weight for this step=-.12578E+00 0.28092E+01 beta (00000377)=0.130315379073753E+02 gamma(00000377)=0.130315379073753E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 377 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000377)=0.000000000000000E+00 (calc=0.135748797619598E+02 read=0.135748797619598E+02) Weight for this step=0.11401E+00 -.23411E+01 beta (00000378)=0.135748797619598E+02 gamma(00000378)=0.135748797619598E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 378 z1= 1 0.308435105055710E-05 0.000000000000000E+00 z1= 2 -.176136379800871E-02 0.000000000000000E+00 z1= 3 0.184557142534660E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000378)=0.000000000000000E+00 (calc=0.125824290799668E+02 read=0.125824290799668E+02) Weight for this step=0.12641E+00 -.28097E+01 beta (00000379)=0.125824290799668E+02 gamma(00000379)=0.125824290799668E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 379 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000379)=0.000000000000000E+00 (calc=0.133817908930390E+02 read=0.133817908930390E+02) Weight for this step=-.11620E+00 0.23796E+01 beta (00000380)=0.133817908930390E+02 gamma(00000380)=0.133817908930390E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 380 z1= 1 -.315389547578216E-05 0.000000000000000E+00 z1= 2 0.147095341701263E-02 0.000000000000000E+00 z1= 3 -.101796245320266E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000380)=0.000000000000000E+00 (calc=0.131035175968836E+02 read=0.131035175968836E+02) Weight for this step=-.12472E+00 0.27582E+01 beta (00000381)=0.131035175968836E+02 gamma(00000381)=0.131035175968836E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 381 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000381)=0.000000000000000E+00 (calc=0.134408300255023E+02 read=0.134408300255023E+02) Weight for this step=0.11223E+00 -.22923E+01 beta (00000382)=0.134408300255023E+02 gamma(00000382)=0.134408300255023E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 382 z1= 1 0.328100634311695E-05 0.000000000000000E+00 z1= 2 -.127880371272743E-02 0.000000000000000E+00 z1= 3 0.112586862683695E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000382)=0.000000000000000E+00 (calc=0.129349610668463E+02 read=0.129349610668463E+02) Weight for this step=0.12723E+00 -.28006E+01 beta (00000383)=0.129349610668463E+02 gamma(00000383)=0.129349610668463E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 383 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000383)=0.000000000000000E+00 (calc=0.134943500523714E+02 read=0.134943500523714E+02) Weight for this step=-.10996E+00 0.22402E+01 beta (00000384)=0.134943500523714E+02 gamma(00000384)=0.134943500523714E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 384 z1= 1 -.337803690248287E-05 0.000000000000000E+00 z1= 2 0.111249936514956E-02 0.000000000000000E+00 z1= 3 -.229893305132313E-07 0.000000000000000E+00 Calculating total response charge density alpha(00000384)=0.000000000000000E+00 (calc=0.126533026813928E+02 read=0.126533026813928E+02) Weight for this step=-.12745E+00 0.27932E+01 beta (00000385)=0.126533026813928E+02 gamma(00000385)=0.126533026813928E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 385 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000385)=0.000000000000000E+00 (calc=0.130168904233344E+02 read=0.130168904233344E+02) Weight for this step=0.11046E+00 -.22447E+01 beta (00000386)=0.130168904233344E+02 gamma(00000386)=0.130168904233344E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 386 z1= 1 0.349368086752493E-05 0.000000000000000E+00 z1= 2 -.969037679933059E-03 0.000000000000000E+00 z1= 3 -.289358134168368E-08 0.000000000000000E+00 Calculating total response charge density alpha(00000386)=0.000000000000000E+00 (calc=0.129062729006450E+02 read=0.129062729006450E+02) Weight for this step=0.12962E+00 -.28280E+01 beta (00000387)=0.129062729006450E+02 gamma(00000387)=0.129062729006450E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 387 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000387)=0.000000000000000E+00 (calc=0.133571597248837E+02 read=0.133571597248837E+02) Weight for this step=-.10461E+00 0.21205E+01 beta (00000388)=0.133571597248837E+02 gamma(00000388)=0.133571597248837E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 388 z1= 1 -.357728884061055E-05 0.000000000000000E+00 z1= 2 0.840220090467947E-03 0.000000000000000E+00 z1= 3 0.106460529828074E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000388)=0.000000000000000E+00 (calc=0.125858317751283E+02 read=0.125858317751283E+02) Weight for this step=-.13053E+00 0.28365E+01 beta (00000389)=0.125858317751283E+02 gamma(00000389)=0.125858317751283E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 389 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000389)=0.000000000000000E+00 (calc=0.134760429776503E+02 read=0.134760429776503E+02) Weight for this step=0.10400E+00 -.21029E+01 beta (00000390)=0.134760429776503E+02 gamma(00000390)=0.134760429776503E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 390 z1= 1 0.351958657916459E-05 0.000000000000000E+00 z1= 2 -.731734077203564E-03 0.000000000000000E+00 z1= 3 -.172613846228755E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000390)=0.000000000000000E+00 (calc=0.129061712129303E+02 read=0.129061712129303E+02) Weight for this step=0.12712E+00 -.27513E+01 beta (00000391)=0.129061712129303E+02 gamma(00000391)=0.129061712129303E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 391 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000391)=0.000000000000000E+00 (calc=0.131950581629851E+02 read=0.131950581629851E+02) Weight for this step=-.10194E+00 0.20562E+01 beta (00000392)=0.131950581629851E+02 gamma(00000392)=0.131950581629851E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 392 z1= 1 -.362885608417175E-05 0.000000000000000E+00 z1= 2 0.745981531161233E-03 0.000000000000000E+00 z1= 3 0.273396605524073E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000392)=0.000000000000000E+00 (calc=0.126542812444308E+02 read=0.126542812444308E+02) Weight for this step=-.12955E+00 0.27930E+01 beta (00000393)=0.126542812444308E+02 gamma(00000393)=0.126542812444308E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 393 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000393)=0.000000000000000E+00 (calc=0.133841499383001E+02 read=0.133841499383001E+02) Weight for this step=0.99371E-01 -.19996E+01 beta (00000394)=0.133841499383001E+02 gamma(00000394)=0.133841499383001E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 394 z1= 1 0.359633796105305E-05 0.000000000000000E+00 z1= 2 -.723044751080653E-03 0.000000000000000E+00 z1= 3 -.339851680686450E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000394)=0.000000000000000E+00 (calc=0.126876730109873E+02 read=0.126876730109873E+02) Weight for this step=0.12749E+00 -.27385E+01 beta (00000395)=0.126876730109873E+02 gamma(00000395)=0.126876730109873E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 395 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000395)=0.000000000000000E+00 (calc=0.132038045765396E+02 read=0.132038045765396E+02) Weight for this step=-.98032E-01 0.19681E+01 beta (00000396)=0.132038045765396E+02 gamma(00000396)=0.132038045765396E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 396 z1= 1 -.363865379217126E-05 0.000000000000000E+00 z1= 2 0.634979313319250E-03 0.000000000000000E+00 z1= 3 0.417205462270305E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000396)=0.000000000000000E+00 (calc=0.127102581571091E+02 read=0.127102581571091E+02) Weight for this step=-.12752E+00 0.27290E+01 beta (00000397)=0.127102581571091E+02 gamma(00000397)=0.127102581571091E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 397 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000397)=0.000000000000000E+00 (calc=0.131579818718247E+02 read=0.131579818718247E+02) Weight for this step=0.95057E-01 -.19040E+01 beta (00000398)=0.131579818718247E+02 gamma(00000398)=0.131579818718247E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 398 z1= 1 0.367846567474748E-05 0.000000000000000E+00 z1= 2 -.431148517535196E-03 0.000000000000000E+00 z1= 3 -.502237059472627E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000398)=0.000000000000000E+00 (calc=0.126877604588753E+02 read=0.126877604588753E+02) Weight for this step=0.12805E+00 -.27309E+01 beta (00000399)=0.126877604588753E+02 gamma(00000399)=0.126877604588753E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 399 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000399)=0.000000000000000E+00 (calc=0.136083939369632E+02 read=0.136083939369632E+02) Weight for this step=-.91758E-01 0.18337E+01 beta (00000400)=0.136083939369632E+02 gamma(00000400)=0.136083939369632E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 400 z1= 1 -.359826032694625E-05 0.000000000000000E+00 z1= 2 0.190024910658445E-03 0.000000000000000E+00 z1= 3 0.526372064885901E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000400)=0.000000000000000E+00 (calc=0.128719373783732E+02 read=0.128719373783732E+02) Weight for this step=-.12394E+00 0.26343E+01 beta (00000401)=0.128719373783732E+02 gamma(00000401)=0.128719373783732E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 401 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000401)=0.000000000000000E+00 (calc=0.132282577984509E+02 read=0.132282577984509E+02) Weight for this step=0.90500E-01 -.18046E+01 beta (00000402)=0.132282577984509E+02 gamma(00000402)=0.132282577984509E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 402 z1= 1 0.365880150319207E-05 0.000000000000000E+00 z1= 2 0.834973158655473E-04 0.000000000000000E+00 z1= 3 -.611982304428037E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000402)=0.000000000000000E+00 (calc=0.129674358772304E+02 read=0.129674358772304E+02) Weight for this step=0.12521E+00 -.26527E+01 beta (00000403)=0.129674358772304E+02 gamma(00000403)=0.129674358772304E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 403 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000403)=0.000000000000000E+00 (calc=0.133464196466581E+02 read=0.133464196466581E+02) Weight for this step=-.85795E-01 0.17070E+01 beta (00000404)=0.133464196466581E+02 gamma(00000404)=0.133464196466581E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 404 z1= 1 -.371390583896614E-05 0.000000000000000E+00 z1= 2 -.280705032072587E-03 0.000000000000000E+00 z1= 3 0.650948769806902E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000404)=0.000000000000000E+00 (calc=0.126603062757557E+02 read=0.126603062757557E+02) Weight for this step=-.12599E+00 0.26611E+01 beta (00000405)=0.126603062757557E+02 gamma(00000405)=0.126603062757557E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 405 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000405)=0.000000000000000E+00 (calc=0.135477412413881E+02 read=0.135477412413881E+02) Weight for this step=0.83720E-01 -.16620E+01 beta (00000406)=0.135477412413881E+02 gamma(00000406)=0.135477412413881E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 406 z1= 1 0.361804831679278E-05 0.000000000000000E+00 z1= 2 0.445888240212498E-03 0.000000000000000E+00 z1= 3 -.679839227900889E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000406)=0.000000000000000E+00 (calc=0.127114666768916E+02 read=0.127114666768916E+02) Weight for this step=0.12191E+00 -.25670E+01 beta (00000407)=0.127114666768916E+02 gamma(00000407)=0.127114666768916E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 407 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000407)=0.000000000000000E+00 (calc=0.130764904689422E+02 read=0.130764904689422E+02) Weight for this step=-.82748E-01 0.16391E+01 beta (00000408)=0.130764904689422E+02 gamma(00000408)=0.130764904689422E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 408 z1= 1 -.368946997887079E-05 0.000000000000000E+00 z1= 2 -.686897950187320E-03 0.000000000000000E+00 z1= 3 0.679211198451534E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000408)=0.000000000000000E+00 (calc=0.129445408073245E+02 read=0.129445408073245E+02) Weight for this step=-.12277E+00 0.25774E+01 beta (00000409)=0.129445408073245E+02 gamma(00000409)=0.129445408073245E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 409 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000409)=0.000000000000000E+00 (calc=0.133572063812707E+02 read=0.133572063812707E+02) Weight for this step=0.77184E-01 -.15255E+01 beta (00000410)=0.133572063812707E+02 gamma(00000410)=0.133572063812707E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 410 z1= 1 0.374706036588342E-05 0.000000000000000E+00 z1= 2 0.927479634521243E-03 0.000000000000000E+00 z1= 3 -.731784780002339E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000410)=0.000000000000000E+00 (calc=0.128095650916903E+02 read=0.128095650916903E+02) Weight for this step=0.12288E+00 -.25726E+01 beta (00000411)=0.128095650916903E+02 gamma(00000411)=0.128095650916903E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 411 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000411)=0.000000000000000E+00 (calc=0.138140886114727E+02 read=0.138140886114727E+02) Weight for this step=-.74003E-01 0.14593E+01 beta (00000412)=0.138140886114727E+02 gamma(00000412)=0.138140886114727E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 412 z1= 1 -.363391926908041E-05 0.000000000000000E+00 z1= 2 -.106201188247809E-02 0.000000000000000E+00 z1= 3 0.697349372328075E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000412)=0.000000000000000E+00 (calc=0.124499131667514E+02 read=0.124499131667514E+02) Weight for this step=-.11755E+00 0.24546E+01 beta (00000413)=0.124499131667514E+02 gamma(00000413)=0.124499131667514E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 413 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000413)=0.000000000000000E+00 (calc=0.133787649097590E+02 read=0.133787649097590E+02) Weight for this step=0.75734E-01 -.14901E+01 beta (00000414)=0.133787649097590E+02 gamma(00000414)=0.133787649097590E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 414 z1= 1 0.355693592595614E-05 0.000000000000000E+00 z1= 2 0.111324644054363E-02 0.000000000000000E+00 z1= 3 -.729228361545751E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000414)=0.000000000000000E+00 (calc=0.130605899516051E+02 read=0.130605899516051E+02) Weight for this step=0.11321E+00 -.23571E+01 beta (00000415)=0.130605899516051E+02 gamma(00000415)=0.130605899516051E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 415 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000415)=0.000000000000000E+00 (calc=0.135228179007108E+02 read=0.135228179007108E+02) Weight for this step=-.71725E-01 0.14083E+01 beta (00000416)=0.135228179007108E+02 gamma(00000416)=0.135228179007108E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 416 z1= 1 -.360897485866493E-05 0.000000000000000E+00 z1= 2 -.106535834618177E-02 0.000000000000000E+00 z1= 3 0.706460358011128E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000416)=0.000000000000000E+00 (calc=0.126275304977541E+02 read=0.126275304977541E+02) Weight for this step=-.11292E+00 0.23447E+01 beta (00000417)=0.126275304977541E+02 gamma(00000417)=0.126275304977541E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 417 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000417)=0.000000000000000E+00 (calc=0.138147934305683E+02 read=0.138147934305683E+02) Weight for this step=0.70771E-01 -.13866E+01 beta (00000418)=0.138147934305683E+02 gamma(00000418)=0.138147934305683E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 418 z1= 1 0.347843557684099E-05 0.000000000000000E+00 z1= 2 0.855620705475901E-03 0.000000000000000E+00 z1= 3 -.721907126675393E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000418)=0.000000000000000E+00 (calc=0.126621225811536E+02 read=0.126621225811536E+02) Weight for this step=0.10667E+00 -.22089E+01 beta (00000419)=0.126621225811536E+02 gamma(00000419)=0.126621225811536E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 419 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000419)=0.000000000000000E+00 (calc=0.135334940445231E+02 read=0.135334940445231E+02) Weight for this step=-.71524E-01 0.13986E+01 beta (00000420)=0.135334940445231E+02 gamma(00000420)=0.135334940445231E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 420 z1= 1 -.343538321197906E-05 0.000000000000000E+00 z1= 2 -.679875609601815E-03 0.000000000000000E+00 z1= 3 0.663910259974496E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000420)=0.000000000000000E+00 (calc=0.128427744910704E+02 read=0.128427744910704E+02) Weight for this step=-.10336E+00 0.21343E+01 beta (00000421)=0.128427744910704E+02 gamma(00000421)=0.128427744910704E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 421 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000421)=0.000000000000000E+00 (calc=0.130972320637599E+02 read=0.130972320637599E+02) Weight for this step=0.69937E-01 -.13651E+01 beta (00000422)=0.130972320637599E+02 gamma(00000422)=0.130972320637599E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 422 z1= 1 0.355054161505029E-05 0.000000000000000E+00 z1= 2 0.621534002788993E-03 0.000000000000000E+00 z1= 3 -.695305420185608E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000422)=0.000000000000000E+00 (calc=0.127561505001919E+02 read=0.127561505001919E+02) Weight for this step=0.10495E+00 -.21611E+01 beta (00000423)=0.127561505001919E+02 gamma(00000423)=0.127561505001919E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 423 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000423)=0.000000000000000E+00 (calc=0.136009960440677E+02 read=0.136009960440677E+02) Weight for this step=-.66251E-01 0.12907E+01 beta (00000424)=0.136009960440677E+02 gamma(00000424)=0.136009960440677E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 424 z1= 1 -.350315878271980E-05 0.000000000000000E+00 z1= 2 -.547642060654080E-03 0.000000000000000E+00 z1= 3 0.607564466720235E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000424)=0.000000000000000E+00 (calc=0.123518136165995E+02 read=0.123518136165995E+02) Weight for this step=-.10172E+00 0.20889E+01 beta (00000425)=0.123518136165995E+02 gamma(00000425)=0.123518136165995E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 425 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000425)=0.000000000000000E+00 (calc=0.137429597652421E+02 read=0.137429597652421E+02) Weight for this step=0.67392E-01 -.13105E+01 beta (00000426)=0.137429597652421E+02 gamma(00000426)=0.137429597652421E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 426 z1= 1 0.332417002043683E-05 0.000000000000000E+00 z1= 2 0.422026353286911E-03 0.000000000000000E+00 z1= 3 -.577895558432728E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000426)=0.000000000000000E+00 (calc=0.127408175125267E+02 read=0.127408175125267E+02) Weight for this step=0.94726E-01 -.19399E+01 beta (00000427)=0.127408175125267E+02 gamma(00000427)=0.127408175125267E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 427 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000427)=0.000000000000000E+00 (calc=0.133045013679117E+02 read=0.133045013679117E+02) Weight for this step=-.67674E-01 0.13139E+01 beta (00000428)=0.133045013679117E+02 gamma(00000428)=0.133045013679117E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 428 z1= 1 -.336402921859592E-05 0.000000000000000E+00 z1= 2 -.212860751469405E-03 0.000000000000000E+00 z1= 3 0.516814810487412E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000428)=0.000000000000000E+00 (calc=0.128353464628649E+02 read=0.128353464628649E+02) Weight for this step=-.94141E-01 0.19224E+01 beta (00000429)=0.128353464628649E+02 gamma(00000429)=0.128353464628649E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 429 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000429)=0.000000000000000E+00 (calc=0.132090521151817E+02 read=0.132090521151817E+02) Weight for this step=0.65196E-01 -.12639E+01 beta (00000430)=0.132090521151817E+02 gamma(00000430)=0.132090521151817E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 430 z1= 1 0.345568304754677E-05 0.000000000000000E+00 z1= 2 -.141169383338177E-03 0.000000000000000E+00 z1= 3 -.528274203776945E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000430)=0.000000000000000E+00 (calc=0.129472394895322E+02 read=0.129472394895322E+02) Weight for this step=0.94804E-01 -.19306E+01 beta (00000431)=0.129472394895322E+02 gamma(00000431)=0.129472394895322E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 431 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000431)=0.000000000000000E+00 (calc=0.135190728141264E+02 read=0.135190728141264E+02) Weight for this step=-.61572E-01 0.11919E+01 beta (00000432)=0.135190728141264E+02 gamma(00000432)=0.135190728141264E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 432 z1= 1 -.347200138584546E-05 0.000000000000000E+00 z1= 2 0.469690044792904E-03 0.000000000000000E+00 z1= 3 0.457602486605676E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000432)=0.000000000000000E+00 (calc=0.125895523028154E+02 read=0.125895523028154E+02) Weight for this step=-.93863E-01 0.19066E+01 beta (00000433)=0.125895523028154E+02 gamma(00000433)=0.125895523028154E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 433 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000433)=0.000000000000000E+00 (calc=0.137837538622083E+02 read=0.137837538622083E+02) Weight for this step=0.61086E-01 -.11807E+01 beta (00000434)=0.137837538622083E+02 gamma(00000434)=0.137837538622083E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 434 z1= 1 0.333708611226918E-05 0.000000000000000E+00 z1= 2 -.699398844076347E-03 0.000000000000000E+00 z1= 3 -.448409663487493E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000434)=0.000000000000000E+00 (calc=0.128837839408683E+02 read=0.128837839408683E+02) Weight for this step=0.88718E-01 -.17975E+01 beta (00000435)=0.128837839408683E+02 gamma(00000435)=0.128837839408683E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 435 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000435)=0.000000000000000E+00 (calc=0.132266197108807E+02 read=0.132266197108807E+02) Weight for this step=-.60706E-01 0.11719E+01 beta (00000436)=0.132266197108807E+02 gamma(00000436)=0.132266197108807E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 436 z1= 1 -.343407201691768E-05 0.000000000000000E+00 z1= 2 0.900452815317272E-03 0.000000000000000E+00 z1= 3 0.406457691743767E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000436)=0.000000000000000E+00 (calc=0.129067967076268E+02 read=0.129067967076268E+02) Weight for this step=-.89511E-01 0.18089E+01 beta (00000437)=0.129067967076268E+02 gamma(00000437)=0.129067967076268E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 437 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000437)=0.000000000000000E+00 (calc=0.128547296033026E+02 read=0.128547296033026E+02) Weight for this step=0.57531E-01 -.11092E+01 beta (00000438)=0.128547296033026E+02 gamma(00000438)=0.128547296033026E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 438 z1= 1 0.364543076266256E-05 0.000000000000000E+00 z1= 2 -.935461943856887E-03 0.000000000000000E+00 z1= 3 -.415973321438775E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000438)=0.000000000000000E+00 (calc=0.127824558443860E+02 read=0.127824558443860E+02) Weight for this step=0.92890E-01 -.18727E+01 beta (00000439)=0.127824558443860E+02 gamma(00000439)=0.127824558443860E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 439 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000439)=0.000000000000000E+00 (calc=0.133184611926670E+02 read=0.133184611926670E+02) Weight for this step=-.52953E-01 0.10196E+01 beta (00000440)=0.133184611926670E+02 gamma(00000440)=0.133184611926670E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 440 z1= 1 -.369896078665152E-05 0.000000000000000E+00 z1= 2 0.810604481258283E-03 0.000000000000000E+00 z1= 3 0.386159868625289E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000440)=0.000000000000000E+00 (calc=0.124654952687681E+02 read=0.124654952687681E+02) Weight for this step=-.91831E-01 0.18475E+01 beta (00000441)=0.124654952687681E+02 gamma(00000441)=0.124654952687681E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 441 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000441)=0.000000000000000E+00 (calc=0.134802932901439E+02 read=0.134802932901439E+02) Weight for this step=0.51605E-01 -.99231E+00 beta (00000442)=0.134802932901439E+02 gamma(00000442)=0.134802932901439E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 442 z1= 1 0.361674075033489E-05 0.000000000000000E+00 z1= 2 -.516541111349057E-03 0.000000000000000E+00 z1= 3 -.370438596550325E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000442)=0.000000000000000E+00 (calc=0.125905814656399E+02 read=0.125905814656399E+02) Weight for this step=0.87497E-01 -.17566E+01 beta (00000443)=0.125905814656399E+02 gamma(00000443)=0.125905814656399E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 443 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000443)=0.000000000000000E+00 (calc=0.133373876732618E+02 read=0.133373876732618E+02) Weight for this step=-.50563E-01 0.97112E+00 beta (00000444)=0.133373876732618E+02 gamma(00000444)=0.133373876732618E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 444 z1= 1 -.363007190928508E-05 0.000000000000000E+00 z1= 2 0.180622442486240E-03 0.000000000000000E+00 z1= 3 0.358373264400073E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000444)=0.000000000000000E+00 (calc=0.132098636244196E+02 read=0.132098636244196E+02) Weight for this step=-.85152E-01 0.17059E+01 beta (00000445)=0.132098636244196E+02 gamma(00000445)=0.132098636244196E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 445 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000445)=0.000000000000000E+00 (calc=0.130285542047167E+02 read=0.130285542047167E+02) Weight for this step=0.46703E-01 -.89596E+00 beta (00000446)=0.130285542047167E+02 gamma(00000446)=0.130285542047167E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 446 z1= 1 0.390309292262227E-05 0.000000000000000E+00 z1= 2 0.129982952726333E-03 0.000000000000000E+00 z1= 3 -.370745092048794E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000446)=0.000000000000000E+00 (calc=0.129522392874696E+02 read=0.129522392874696E+02) Weight for this step=0.88753E-01 -.17746E+01 beta (00000447)=0.129522392874696E+02 gamma(00000447)=0.129522392874696E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 447 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000447)=0.000000000000000E+00 (calc=0.132092081359833E+02 read=0.132092081359833E+02) Weight for this step=-.42355E-01 0.81156E+00 beta (00000448)=0.132092081359833E+02 gamma(00000448)=0.132092081359833E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 448 z1= 1 -.403731442919116E-05 0.000000000000000E+00 z1= 2 -.343879506753389E-03 0.000000000000000E+00 z1= 3 0.391038914596565E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000448)=0.000000000000000E+00 (calc=0.129489725602347E+02 read=0.129489725602347E+02) Weight for this step=-.89186E-01 0.17803E+01 beta (00000449)=0.129489725602347E+02 gamma(00000449)=0.129489725602347E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 449 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000449)=0.000000000000000E+00 (calc=0.136503991375937E+02 read=0.136503991375937E+02) Weight for this step=0.38561E-01 -.73788E+00 beta (00000450)=0.136503991375937E+02 gamma(00000450)=0.136503991375937E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 450 z1= 1 0.401721308441148E-05 0.000000000000000E+00 z1= 2 0.462324990944856E-03 0.000000000000000E+00 z1= 3 -.377777717645682E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000450)=0.000000000000000E+00 (calc=0.124501778501954E+02 read=0.124501778501954E+02) Weight for this step=0.86507E-01 -.17242E+01 beta (00000451)=0.124501778501954E+02 gamma(00000451)=0.124501778501954E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 451 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000451)=0.000000000000000E+00 (calc=0.137434161894415E+02 read=0.137434161894415E+02) Weight for this step=-.37591E-01 0.71836E+00 beta (00000452)=0.137434161894415E+02 gamma(00000452)=0.137434161894415E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 452 z1= 1 -.382862144499355E-05 0.000000000000000E+00 z1= 2 -.621767500823111E-03 0.000000000000000E+00 z1= 3 0.375226719293888E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000452)=0.000000000000000E+00 (calc=0.123492999674624E+02 read=0.123492999674624E+02) Weight for this step=-.80209E-01 0.15962E+01 beta (00000453)=0.123492999674624E+02 gamma(00000453)=0.123492999674624E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 453 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000453)=0.000000000000000E+00 (calc=0.136342991977854E+02 read=0.136342991977854E+02) Weight for this step=0.37454E-01 -.71486E+00 beta (00000454)=0.136342991977854E+02 gamma(00000454)=0.136342991977854E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 454 z1= 1 0.367572793649740E-05 0.000000000000000E+00 z1= 2 0.740977985282658E-03 0.000000000000000E+00 z1= 3 -.313670673498991E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000454)=0.000000000000000E+00 (calc=0.124949114503783E+02 read=0.124949114503783E+02) Weight for this step=0.74500E-01 -.14801E+01 beta (00000455)=0.124949114503783E+02 gamma(00000455)=0.124949114503783E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 455 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000455)=0.000000000000000E+00 (calc=0.136130166845993E+02 read=0.136130166845993E+02) Weight for this step=-.36848E-01 0.70251E+00 beta (00000456)=0.136130166845993E+02 gamma(00000456)=0.136130166845993E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 456 z1= 1 -.358706103227233E-05 0.000000000000000E+00 z1= 2 -.936906525542826E-03 0.000000000000000E+00 z1= 3 0.305161748468844E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000456)=0.000000000000000E+00 (calc=0.127298154592947E+02 read=0.127298154592947E+02) Weight for this step=-.70205E-01 0.13923E+01 beta (00000457)=0.127298154592947E+02 gamma(00000457)=0.127298154592947E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 457 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000457)=0.000000000000000E+00 (calc=0.134663545657473E+02 read=0.134663545657473E+02) Weight for this step=0.35685E-01 -.67966E+00 beta (00000458)=0.134663545657473E+02 gamma(00000458)=0.134663545657473E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 458 z1= 1 0.361745209026803E-05 0.000000000000000E+00 z1= 2 0.110740060609719E-02 0.000000000000000E+00 z1= 3 -.225432269697812E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000458)=0.000000000000000E+00 (calc=0.129361010162124E+02 read=0.129361010162124E+02) Weight for this step=0.68150E-01 -.13492E+01 beta (00000459)=0.129361010162124E+02 gamma(00000459)=0.129361010162124E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 459 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000459)=0.000000000000000E+00 (calc=0.134362676828306E+02 read=0.134362676828306E+02) Weight for this step=-.33595E-01 0.63925E+00 beta (00000460)=0.134362676828306E+02 gamma(00000460)=0.134362676828306E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 460 z1= 1 -.371429502775888E-05 0.000000000000000E+00 z1= 2 -.121695328941353E-02 0.000000000000000E+00 z1= 3 0.222373480037721E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000460)=0.000000000000000E+00 (calc=0.127149953015401E+02 read=0.127149953015401E+02) Weight for this step=-.67297E-01 0.13301E+01 beta (00000461)=0.127149953015401E+02 gamma(00000461)=0.127149953015401E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 461 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000461)=0.000000000000000E+00 (calc=0.133073122674314E+02 read=0.133073122674314E+02) Weight for this step=0.31931E-01 -.60704E+00 beta (00000462)=0.133073122674314E+02 gamma(00000462)=0.133073122674314E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 462 z1= 1 0.377726007610730E-05 0.000000000000000E+00 z1= 2 0.123537531927305E-02 0.000000000000000E+00 z1= 3 -.116130022030777E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000462)=0.000000000000000E+00 (calc=0.130288453076303E+02 read=0.130288453076303E+02) Weight for this step=0.65918E-01 -.13007E+01 beta (00000463)=0.130288453076303E+02 gamma(00000463)=0.130288453076303E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 463 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000463)=0.000000000000000E+00 (calc=0.134211060905844E+02 read=0.134211060905844E+02) Weight for this step=-.29202E-01 0.55467E+00 beta (00000464)=0.134211060905844E+02 gamma(00000464)=0.134211060905844E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 464 z1= 1 -.389719241943292E-05 0.000000000000000E+00 z1= 2 -.114511682555913E-02 0.000000000000000E+00 z1= 3 0.962383694459203E-07 0.000000000000000E+00 Calculating total response charge density alpha(00000464)=0.000000000000000E+00 (calc=0.126554462145019E+02 read=0.126554462145019E+02) Weight for this step=-.65457E-01 0.12898E+01 beta (00000465)=0.126554462145019E+02 gamma(00000465)=0.126554462145019E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 465 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000465)=0.000000000000000E+00 (calc=0.134457826308683E+02 read=0.134457826308683E+02) Weight for this step=0.27481E-01 -.52152E+00 beta (00000466)=0.134457826308683E+02 gamma(00000466)=0.134457826308683E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 466 z1= 1 0.388272020129246E-05 0.000000000000000E+00 z1= 2 0.100079602373440E-02 0.000000000000000E+00 z1= 3 0.103615708450366E-07 0.000000000000000E+00 Calculating total response charge density alpha(00000466)=0.000000000000000E+00 (calc=0.128140938876774E+02 read=0.128140938876774E+02) Weight for this step=0.62987E-01 -.12394E+01 beta (00000467)=0.128140938876774E+02 gamma(00000467)=0.128140938876774E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 467 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000467)=0.000000000000000E+00 (calc=0.136873194859020E+02 read=0.136873194859020E+02) Weight for this step=-.25521E-01 0.48392E+00 beta (00000468)=0.136873194859020E+02 gamma(00000468)=0.136873194859020E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 468 z1= 1 -.385435846205623E-05 0.000000000000000E+00 z1= 2 -.837717180515994E-03 0.000000000000000E+00 z1= 3 -.441254881136492E-08 0.000000000000000E+00 Calculating total response charge density alpha(00000468)=0.000000000000000E+00 (calc=0.126931626857742E+02 read=0.126931626857742E+02) Weight for this step=-.60224E-01 0.11834E+01 beta (00000469)=0.126931626857742E+02 gamma(00000469)=0.126931626857742E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 469 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000469)=0.000000000000000E+00 (calc=0.136810341469459E+02 read=0.136810341469459E+02) Weight for this step=0.24321E-01 -.46080E+00 beta (00000470)=0.136810341469459E+02 gamma(00000470)=0.136810341469459E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 470 z1= 1 0.380378445662252E-05 0.000000000000000E+00 z1= 2 0.602975479098504E-03 0.000000000000000E+00 z1= 3 0.106929277971673E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000470)=0.000000000000000E+00 (calc=0.127563523479081E+02 read=0.127563523479081E+02) Weight for this step=0.57073E-01 -.11200E+01 beta (00000471)=0.127563523479081E+02 gamma(00000471)=0.127563523479081E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 471 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000471)=0.000000000000000E+00 (calc=0.133838540435056E+02 read=0.133838540435056E+02) Weight for this step=-.23067E-01 0.43673E+00 beta (00000472)=0.133838540435056E+02 gamma(00000472)=0.133838540435056E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 472 z1= 1 -.385238014576224E-05 0.000000000000000E+00 z1= 2 -.376681801736627E-03 0.000000000000000E+00 z1= 3 -.116924598616810E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000472)=0.000000000000000E+00 (calc=0.126367552995957E+02 read=0.126367552995957E+02) Weight for this step=-.55558E-01 0.10889E+01 beta (00000473)=0.126367552995957E+02 gamma(00000473)=0.126367552995957E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 473 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000473)=0.000000000000000E+00 (calc=0.134964239947119E+02 read=0.134964239947119E+02) Weight for this step=0.21467E-01 -.40615E+00 beta (00000474)=0.134964239947119E+02 gamma(00000474)=0.134964239947119E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 474 z1= 1 0.384661644548022E-05 0.000000000000000E+00 z1= 2 0.138496659420622E-03 0.000000000000000E+00 z1= 3 0.192700810342064E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000474)=0.000000000000000E+00 (calc=0.127392694980907E+02 read=0.127392694980907E+02) Weight for this step=0.53090E-01 -.10392E+01 beta (00000475)=0.127392694980907E+02 gamma(00000475)=0.127392694980907E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 475 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000475)=0.000000000000000E+00 (calc=0.133043228983343E+02 read=0.133043228983343E+02) Weight for this step=-.19933E-01 0.37690E+00 beta (00000476)=0.133043228983343E+02 gamma(00000476)=0.133043228983343E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 476 z1= 1 -.393603089376016E-05 0.000000000000000E+00 z1= 2 -.361349867333697E-05 0.000000000000000E+00 z1= 3 -.185416828925148E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000476)=0.000000000000000E+00 (calc=0.126415231247151E+02 read=0.126415231247151E+02) Weight for this step=-.51845E-01 0.10136E+01 beta (00000477)=0.126415231247151E+02 gamma(00000477)=0.126415231247151E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 477 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000477)=0.000000000000000E+00 (calc=0.133306153906395E+02 read=0.133306153906395E+02) Weight for this step=0.18214E-01 -.34418E+00 beta (00000478)=0.133306153906395E+02 gamma(00000478)=0.133306153906395E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 478 z1= 1 0.400483632541143E-05 0.000000000000000E+00 z1= 2 -.892581267927213E-04 0.000000000000000E+00 z1= 3 0.234680171025024E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000478)=0.000000000000000E+00 (calc=0.126280433653617E+02 read=0.126280433653617E+02) Weight for this step=0.50085E-01 -.97812E+00 beta (00000479)=0.126280433653617E+02 gamma(00000479)=0.126280433653617E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 479 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000479)=0.000000000000000E+00 (calc=0.133935295738204E+02 read=0.133935295738204E+02) Weight for this step=-.16553E-01 0.31262E+00 beta (00000480)=0.133935295738204E+02 gamma(00000480)=0.133935295738204E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 480 z1= 1 -.406047907299282E-05 0.000000000000000E+00 z1= 2 0.171129993285586E-03 0.000000000000000E+00 z1= 3 -.259820994054220E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000480)=0.000000000000000E+00 (calc=0.126439269780216E+02 read=0.126439269780216E+02) Weight for this step=-.48055E-01 0.93749E+00 beta (00000481)=0.126439269780216E+02 gamma(00000481)=0.126439269780216E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 481 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000481)=0.000000000000000E+00 (calc=0.134762718104060E+02 read=0.134762718104060E+02) Weight for this step=0.14973E-01 -.28263E+00 beta (00000482)=0.134762718104060E+02 gamma(00000482)=0.134762718104060E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 482 z1= 1 0.410442487184691E-05 0.000000000000000E+00 z1= 2 -.274985388259063E-03 0.000000000000000E+00 z1= 3 0.286610254445234E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000482)=0.000000000000000E+00 (calc=0.127040159358471E+02 read=0.127040159358471E+02) Weight for this step=0.45835E-01 -.89332E+00 beta (00000483)=0.127040159358471E+02 gamma(00000483)=0.127040159358471E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 483 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000483)=0.000000000000000E+00 (calc=0.136554971595844E+02 read=0.136554971595844E+02) Weight for this step=-.13451E-01 0.25378E+00 beta (00000484)=0.136554971595844E+02 gamma(00000484)=0.136554971595844E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 484 z1= 1 -.411075902353878E-05 0.000000000000000E+00 z1= 2 0.373607202666281E-03 0.000000000000000E+00 z1= 3 -.296537459572668E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000484)=0.000000000000000E+00 (calc=0.126719379371227E+02 read=0.126719379371227E+02) Weight for this step=-.43305E-01 0.84324E+00 beta (00000485)=0.126719379371227E+02 gamma(00000485)=0.126719379371227E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 485 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000485)=0.000000000000000E+00 (calc=0.132368008344103E+02 read=0.132368008344103E+02) Weight for this step=0.12191E-01 -.22992E+00 beta (00000486)=0.132368008344103E+02 gamma(00000486)=0.132368008344103E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 486 z1= 1 0.426985814170298E-05 0.000000000000000E+00 z1= 2 -.477543466164154E-03 0.000000000000000E+00 z1= 3 0.325889418886056E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000486)=0.000000000000000E+00 (calc=0.124437256634576E+02 read=0.124437256634576E+02) Weight for this step=0.42077E-01 -.81862E+00 beta (00000487)=0.124437256634576E+02 gamma(00000487)=0.124437256634576E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 487 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000487)=0.000000000000000E+00 (calc=0.134512608676438E+02 read=0.134512608676438E+02) Weight for this step=-.10689E-01 0.20152E+00 beta (00000488)=0.134512608676438E+02 gamma(00000488)=0.134512608676438E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 488 z1= 1 -.428405639035030E-05 0.000000000000000E+00 z1= 2 0.507265177128253E-03 0.000000000000000E+00 z1= 3 -.401935508998581E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000488)=0.000000000000000E+00 (calc=0.128384065191086E+02 read=0.128384065191086E+02) Weight for this step=-.39460E-01 0.76711E+00 beta (00000489)=0.128384065191086E+02 gamma(00000489)=0.128384065191086E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 489 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000489)=0.000000000000000E+00 (calc=0.132658316068932E+02 read=0.132658316068932E+02) Weight for this step=0.91276E-02 -.17203E+00 beta (00000490)=0.132658316068932E+02 gamma(00000490)=0.132658316068932E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 490 z1= 1 0.450465773829505E-05 0.000000000000000E+00 z1= 2 -.576614036274102E-03 0.000000000000000E+00 z1= 3 0.406563605367044E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000490)=0.000000000000000E+00 (calc=0.125999664114415E+02 read=0.125999664114415E+02) Weight for this step=0.38652E-01 -.75088E+00 beta (00000491)=0.125999664114415E+02 gamma(00000491)=0.125999664114415E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 491 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000491)=0.000000000000000E+00 (calc=0.134509688544327E+02 read=0.134509688544327E+02) Weight for this step=-.75423E-02 0.14211E+00 beta (00000492)=0.134509688544327E+02 gamma(00000492)=0.134509688544327E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 492 z1= 1 -.456365775917782E-05 0.000000000000000E+00 z1= 2 0.648837667894138E-03 0.000000000000000E+00 z1= 3 -.469353097401075E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000492)=0.000000000000000E+00 (calc=0.127242824294439E+02 read=0.127242824294439E+02) Weight for this step=-.36585E-01 0.71029E+00 beta (00000493)=0.127242824294439E+02 gamma(00000493)=0.127242824294439E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 493 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000493)=0.000000000000000E+00 (calc=0.132863303758182E+02 read=0.132863303758182E+02) Weight for this step=0.60352E-02 -.11369E+00 beta (00000494)=0.132863303758182E+02 gamma(00000494)=0.132863303758182E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 494 z1= 1 0.473671558561158E-05 0.000000000000000E+00 z1= 2 -.798264601193603E-03 0.000000000000000E+00 z1= 3 0.445719906998584E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000494)=0.000000000000000E+00 (calc=0.124537545091124E+02 read=0.124537545091124E+02) Weight for this step=0.35343E-01 -.68585E+00 beta (00000495)=0.124537545091124E+02 gamma(00000495)=0.124537545091124E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 495 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000495)=0.000000000000000E+00 (calc=0.134982416403500E+02 read=0.134982416403500E+02) Weight for this step=-.45259E-02 0.85241E-01 beta (00000496)=0.134982416403500E+02 gamma(00000496)=0.134982416403500E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 496 z1= 1 -.471992126898453E-05 0.000000000000000E+00 z1= 2 0.848303688547713E-03 0.000000000000000E+00 z1= 3 -.552592860073525E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000496)=0.000000000000000E+00 (calc=0.128385631395059E+02 read=0.128385631395059E+02) Weight for this step=-.32834E-01 0.63691E+00 beta (00000497)=0.128385631395059E+02 gamma(00000497)=0.128385631395059E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 497 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000497)=0.000000000000000E+00 (calc=0.133352467450784E+02 read=0.133352467450784E+02) Weight for this step=0.30347E-02 -.57150E-01 beta (00000498)=0.133352467450784E+02 gamma(00000498)=0.133352467450784E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 498 z1= 1 0.494108690180352E-05 0.000000000000000E+00 z1= 2 -.918828559944174E-03 0.000000000000000E+00 z1= 3 0.500210080791805E-06 0.000000000000000E+00 Calculating total response charge density alpha(00000498)=0.000000000000000E+00 (calc=0.126817729924288E+02 read=0.126817729924288E+02) Weight for this step=0.31764E-01 -.61599E+00 beta (00000499)=0.126817729924288E+02 gamma(00000499)=0.126817729924288E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 499 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000499)=0.000000000000000E+00 (calc=0.134573919767135E+02 read=0.134573919767135E+02) Weight for this step=-.15029E-02 0.28301E-01 beta (00000500)=0.134573919767135E+02 gamma(00000500)=0.134573919767135E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 500 z1= 1 -.502620231023322E-05 0.000000000000000E+00 z1= 2 0.105285130001619E-02 0.000000000000000E+00 z1= 3 -.662713477186878E-06 0.000000000000000E+00 alpha(00000500)=0.000000000000000E+00 (calc=0.127047234459536E+02 read=0.127047234459536E+02) Weight for this step=-.30009E-01 0.58187E+00 beta (00000501)=0.127047234459536E+02 gamma(00000501)=0.127047234459536E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Writing Cube file for response charge density Writing Cube file for response charge density Reading Pre-calculated lanczos coefficents from ./out/ch4-pr.beta_gamma_z.3 500 steps succesfully read for polarization index 3 Calculating response coefficients Resonance frequency mode enabled Charge Response renormalization factor: 0.25097E+05 0.00000E+00 Norm of initial Lanczos vectors= 1.841652243191165 Starting Lanczos loop 3 Lanczos iteration: 1 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal alpha(00000001)=0.000000000000000E+00 (calc=0.171988313361988E+01 read=0.171988313361988E+01) Weight for this step=-.78845E+00 -.25097E+02 beta (00000002)=0.171988313361988E+01 gamma(00000002)=0.171988313361988E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 2 z1= 1 0.663024870149157E-06 0.000000000000000E+00 z1= 2 -.221874526081141E-05 0.000000000000000E+00 z1= 3 0.124520560488345E+01 0.000000000000000E+00 Calculating total response charge density alpha(00000002)=0.000000000000000E+00 (calc=0.476672412555626E+01 read=0.476672412555626E+01) Weight for this step=-.86693E+00 -.95525E+01 beta (00000003)=0.476672412555626E+01 gamma(00000003)=0.476672412555626E+01 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 3 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000003)=0.000000000000000E+00 (calc=0.135455786704734E+02 read=0.135455786704734E+02) Weight for this step=0.16743E+00 0.77432E+01 beta (00000004)=0.135455786704734E+02 gamma(00000004)=0.135455786704734E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 4 z1= 1 -.218065605493115E-06 0.000000000000000E+00 z1= 2 0.772582398582389E-06 0.000000000000000E+00 z1= 3 -.355940981942414E+00 0.000000000000000E+00 Calculating total response charge density alpha(00000004)=0.000000000000000E+00 (calc=0.127184753500732E+02 read=0.127184753500732E+02) Weight for this step=0.31260E+00 0.37358E+01 beta (00000005)=0.127184753500732E+02 gamma(00000005)=0.127184753500732E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 5 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000005)=0.000000000000000E+00 (calc=0.134778619466885E+02 read=0.134778619466885E+02) Weight for this step=-.16252E+00 -.80545E+01 beta (00000006)=0.134778619466885E+02 gamma(00000006)=0.134778619466885E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 6 z1= 1 0.220907282646955E-06 0.000000000000000E+00 z1= 2 -.747562628365119E-06 0.000000000000000E+00 z1= 3 0.303457752222706E+00 0.000000000000000E+00 Calculating total response charge density alpha(00000006)=0.000000000000000E+00 (calc=0.128879311184969E+02 read=0.128879311184969E+02) Weight for this step=-.30228E+00 -.39165E+01 beta (00000007)=0.128879311184969E+02 gamma(00000007)=0.128879311184969E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 7 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000007)=0.000000000000000E+00 (calc=0.133738577579146E+02 read=0.133738577579146E+02) Weight for this step=0.15491E+00 0.82242E+01 beta (00000008)=0.133738577579146E+02 gamma(00000008)=0.133738577579146E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 8 z1= 1 -.240226473592576E-06 0.000000000000000E+00 z1= 2 0.768083316857431E-06 0.000000000000000E+00 z1= 3 -.273900448948058E+00 0.000000000000000E+00 Calculating total response charge density alpha(00000008)=0.000000000000000E+00 (calc=0.128588191679613E+02 read=0.128588191679613E+02) Weight for this step=0.29826E+00 0.41767E+01 beta (00000009)=0.128588191679613E+02 gamma(00000009)=0.128588191679613E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 9 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000009)=0.000000000000000E+00 (calc=0.134143954539029E+02 read=0.134143954539029E+02) Weight for this step=-.14626E+00 -.83410E+01 beta (00000010)=0.134143954539029E+02 gamma(00000010)=0.134143954539029E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 10 z1= 1 0.261131678431874E-06 0.000000000000000E+00 z1= 2 -.825782731452468E-06 0.000000000000000E+00 z1= 3 0.250162592949930E+00 0.000000000000000E+00 Calculating total response charge density alpha(00000010)=0.000000000000000E+00 (calc=0.128242598091633E+02 read=0.128242598091633E+02) Weight for this step=-.29243E+00 -.44108E+01 beta (00000011)=0.128242598091633E+02 gamma(00000011)=0.128242598091633E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 11 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000011)=0.000000000000000E+00 (calc=0.134762977044858E+02 read=0.134762977044858E+02) Weight for this step=0.13841E+00 0.84996E+01 beta (00000012)=0.134762977044858E+02 gamma(00000012)=0.134762977044858E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 12 z1= 1 -.281917697415597E-06 0.000000000000000E+00 z1= 2 0.921156892876973E-06 0.000000000000000E+00 z1= 3 -.228558621650782E+00 0.000000000000000E+00 Calculating total response charge density alpha(00000012)=0.000000000000000E+00 (calc=0.128064561057340E+02 read=0.128064561057340E+02) Weight for this step=0.28437E+00 0.46103E+01 beta (00000013)=0.128064561057340E+02 gamma(00000013)=0.128064561057340E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 13 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000013)=0.000000000000000E+00 (calc=0.134982188405027E+02 read=0.134982188405027E+02) Weight for this step=-.13147E+00 -.87085E+01 beta (00000014)=0.134982188405027E+02 gamma(00000014)=0.134982188405027E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 14 z1= 1 0.297585411956989E-06 0.000000000000000E+00 z1= 2 -.102974030132230E-05 0.000000000000000E+00 z1= 3 0.209175967422532E+00 0.000000000000000E+00 Calculating total response charge density alpha(00000014)=0.000000000000000E+00 (calc=0.128005687364523E+02 read=0.128005687364523E+02) Weight for this step=-.27553E+00 -.47963E+01 beta (00000015)=0.128005687364523E+02 gamma(00000015)=0.128005687364523E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 15 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000015)=0.000000000000000E+00 (calc=0.134714910841036E+02 read=0.134714910841036E+02) Weight for this step=0.12492E+00 0.89379E+01 beta (00000016)=0.134714910841036E+02 gamma(00000016)=0.134714910841036E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 16 z1= 1 -.303854358656359E-06 0.000000000000000E+00 z1= 2 0.109461702337406E-05 0.000000000000000E+00 z1= 3 -.192297212726838E+00 0.000000000000000E+00 Calculating total response charge density alpha(00000016)=0.000000000000000E+00 (calc=0.127887234806921E+02 read=0.127887234806921E+02) Weight for this step=0.26721E+00 0.49918E+01 beta (00000017)=0.127887234806921E+02 gamma(00000017)=0.127887234806921E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 17 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000017)=0.000000000000000E+00 (calc=0.134266128561788E+02 read=0.134266128561788E+02) Weight for this step=-.11830E+00 -.91595E+01 beta (00000018)=0.134266128561788E+02 gamma(00000018)=0.134266128561788E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 18 z1= 1 0.300869893649525E-06 0.000000000000000E+00 z1= 2 -.113334599945408E-05 0.000000000000000E+00 z1= 3 0.177688788793802E+00 0.000000000000000E+00 Calculating total response charge density alpha(00000018)=0.000000000000000E+00 (calc=0.127825646126019E+02 read=0.127825646126019E+02) Weight for this step=-.25960E+00 -.52012E+01 beta (00000019)=0.127825646126019E+02 gamma(00000019)=0.127825646126019E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 19 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000019)=0.000000000000000E+00 (calc=0.134080184983689E+02 read=0.134080184983689E+02) Weight for this step=0.11138E+00 0.93546E+01 beta (00000020)=0.134080184983689E+02 gamma(00000020)=0.134080184983689E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 20 z1= 1 -.298949234518926E-06 0.000000000000000E+00 z1= 2 0.117784470543119E-05 0.000000000000000E+00 z1= 3 -.164706990139644E+00 0.000000000000000E+00 Calculating total response charge density alpha(00000020)=0.000000000000000E+00 (calc=0.128007404121685E+02 read=0.128007404121685E+02) Weight for this step=0.25223E+00 0.54153E+01 beta (00000021)=0.128007404121685E+02 gamma(00000021)=0.128007404121685E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 21 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000021)=0.000000000000000E+00 (calc=0.134207211905906E+02 read=0.134207211905906E+02) Weight for this step=-.10419E+00 -.95215E+01 beta (00000022)=0.134207211905906E+02 gamma(00000022)=0.134207211905906E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 22 z1= 1 0.288982807469069E-06 0.000000000000000E+00 z1= 2 -.121029811412195E-05 0.000000000000000E+00 z1= 3 0.153073333256714E+00 0.000000000000000E+00 Calculating total response charge density alpha(00000022)=0.000000000000000E+00 (calc=0.128225869589224E+02 read=0.128225869589224E+02) Weight for this step=-.24495E+00 -.56295E+01 beta (00000023)=0.128225869589224E+02 gamma(00000023)=0.128225869589224E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 23 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000023)=0.000000000000000E+00 (calc=0.134332940013601E+02 read=0.134332940013601E+02) Weight for this step=0.96981E-01 0.96782E+01 beta (00000024)=0.134332940013601E+02 gamma(00000024)=0.134332940013601E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 24 z1= 1 -.279647892602200E-06 0.000000000000000E+00 z1= 2 0.123680828741280E-05 0.000000000000000E+00 z1= 3 -.142654243316873E+00 0.000000000000000E+00 Calculating total response charge density alpha(00000024)=0.000000000000000E+00 (calc=0.128311425405846E+02 read=0.128311425405846E+02) Weight for this step=0.23782E+00 0.58452E+01 beta (00000025)=0.128311425405846E+02 gamma(00000025)=0.128311425405846E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 25 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000025)=0.000000000000000E+00 (calc=0.134383817111015E+02 read=0.134383817111015E+02) Weight for this step=-.89855E-01 -.98342E+01 beta (00000026)=0.134383817111015E+02 gamma(00000026)=0.134383817111015E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 26 z1= 1 0.294179617131628E-06 0.000000000000000E+00 z1= 2 -.128086543713996E-05 0.000000000000000E+00 z1= 3 0.133199149916755E+00 0.000000000000000E+00 Calculating total response charge density alpha(00000026)=0.000000000000000E+00 (calc=0.128182296551777E+02 read=0.128182296551777E+02) Weight for this step=-.23072E+00 -.60601E+01 beta (00000027)=0.128182296551777E+02 gamma(00000027)=0.128182296551777E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 27 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000027)=0.000000000000000E+00 (calc=0.134102237461998E+02 read=0.134102237461998E+02) Weight for this step=0.82892E-01 0.10000E+02 beta (00000028)=0.134102237461998E+02 gamma(00000028)=0.134102237461998E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 28 z1= 1 -.320976764538173E-06 0.000000000000000E+00 z1= 2 0.133901508960128E-05 0.000000000000000E+00 z1= 3 -.124698680014893E+00 0.000000000000000E+00 Calculating total response charge density alpha(00000028)=0.000000000000000E+00 (calc=0.127846800785557E+02 read=0.127846800785557E+02) Weight for this step=0.22384E+00 0.62808E+01 beta (00000029)=0.127846800785557E+02 gamma(00000029)=0.127846800785557E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 29 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000029)=0.000000000000000E+00 (calc=0.134134193817761E+02 read=0.134134193817761E+02) Weight for this step=-.75979E-01 -.10168E+02 beta (00000030)=0.134134193817761E+02 gamma(00000030)=0.134134193817761E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 30 z1= 1 0.338562926681949E-06 0.000000000000000E+00 z1= 2 -.138983355372016E-05 0.000000000000000E+00 z1= 3 0.116545365572387E+00 0.000000000000000E+00 Calculating total response charge density alpha(00000030)=0.000000000000000E+00 (calc=0.128191564641331E+02 read=0.128191564641331E+02) Weight for this step=-.21629E+00 -.64826E+01 beta (00000031)=0.128191564641331E+02 gamma(00000031)=0.128191564641331E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 31 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000031)=0.000000000000000E+00 (calc=0.134293990269944E+02 read=0.134293990269944E+02) Weight for this step=0.68962E-01 0.10309E+02 beta (00000032)=0.134293990269944E+02 gamma(00000032)=0.134293990269944E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 32 z1= 1 -.341784320734338E-06 0.000000000000000E+00 z1= 2 0.141901826804464E-05 0.000000000000000E+00 z1= 3 -.109214842777851E+00 0.000000000000000E+00 Calculating total response charge density alpha(00000032)=0.000000000000000E+00 (calc=0.127671198794421E+02 read=0.127671198794421E+02) Weight for this step=0.20906E+00 0.66905E+01 beta (00000033)=0.127671198794421E+02 gamma(00000033)=0.127671198794421E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 33 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000033)=0.000000000000000E+00 (calc=0.133586616949687E+02 read=0.133586616949687E+02) Weight for this step=-.62344E-01 -.10500E+02 beta (00000034)=0.133586616949687E+02 gamma(00000034)=0.133586616949687E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 34 z1= 1 0.350529223967853E-06 0.000000000000000E+00 z1= 2 -.142378112529592E-05 0.000000000000000E+00 z1= 3 0.102544092984169E+00 0.000000000000000E+00 Calculating total response charge density alpha(00000034)=0.000000000000000E+00 (calc=0.127703298345296E+02 read=0.127703298345296E+02) Weight for this step=-.20207E+00 -.69088E+01 beta (00000035)=0.127703298345296E+02 gamma(00000035)=0.127703298345296E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 35 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000035)=0.000000000000000E+00 (calc=0.134311087248697E+02 read=0.134311087248697E+02) Weight for this step=0.55399E-01 0.10630E+02 beta (00000036)=0.134311087248697E+02 gamma(00000036)=0.134311087248697E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 36 z1= 1 -.356806888056338E-06 0.000000000000000E+00 z1= 2 0.143203887414977E-05 0.000000000000000E+00 z1= 3 -.958472619747496E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000036)=0.000000000000000E+00 (calc=0.128060595749493E+02 read=0.128060595749493E+02) Weight for this step=0.19404E+00 0.70870E+01 beta (00000037)=0.128060595749493E+02 gamma(00000037)=0.128060595749493E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 37 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000037)=0.000000000000000E+00 (calc=0.133888950734320E+02 read=0.133888950734320E+02) Weight for this step=-.48738E-01 -.10786E+02 beta (00000038)=0.133888950734320E+02 gamma(00000038)=0.133888950734320E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 38 z1= 1 0.361313651571884E-06 0.000000000000000E+00 z1= 2 -.145878397683676E-05 0.000000000000000E+00 z1= 3 0.901628873529649E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000038)=0.000000000000000E+00 (calc=0.127549655687250E+02 read=0.127549655687250E+02) Weight for this step=-.18717E+00 -.73058E+01 beta (00000039)=0.127549655687250E+02 gamma(00000039)=0.127549655687250E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 39 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000039)=0.000000000000000E+00 (calc=0.133497030376504E+02 read=0.133497030376504E+02) Weight for this step=0.42128E-01 0.10947E+02 beta (00000040)=0.133497030376504E+02 gamma(00000040)=0.133497030376504E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 40 z1= 1 -.360471646850512E-06 0.000000000000000E+00 z1= 2 0.147326742005376E-05 0.000000000000000E+00 z1= 3 -.847503407324605E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000040)=0.000000000000000E+00 (calc=0.126995484221466E+02 read=0.126995484221466E+02) Weight for this step=0.18007E+00 0.75172E+01 beta (00000041)=0.126995484221466E+02 gamma(00000041)=0.126995484221466E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 41 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000041)=0.000000000000000E+00 (calc=0.133246744291924E+02 read=0.133246744291924E+02) Weight for this step=-.35594E-01 -.11120E+02 beta (00000042)=0.133246744291924E+02 gamma(00000042)=0.133246744291924E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 42 z1= 1 0.353902049887939E-06 0.000000000000000E+00 z1= 2 -.147642381517071E-05 0.000000000000000E+00 z1= 3 0.794598584147741E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000042)=0.000000000000000E+00 (calc=0.127528434792520E+02 read=0.127528434792520E+02) Weight for this step=-.17254E+00 -.77108E+01 beta (00000043)=0.127528434792520E+02 gamma(00000043)=0.127528434792520E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 43 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000043)=0.000000000000000E+00 (calc=0.133691964378152E+02 read=0.133691964378152E+02) Weight for this step=0.28938E-01 0.11223E+02 beta (00000044)=0.133691964378152E+02 gamma(00000044)=0.133691964378152E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 44 z1= 1 -.361257604872376E-06 0.000000000000000E+00 z1= 2 0.148742638145141E-05 0.000000000000000E+00 z1= 3 -.746055315154542E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000044)=0.000000000000000E+00 (calc=0.127653035038065E+02 read=0.127653035038065E+02) Weight for this step=0.16516E+00 0.79048E+01 beta (00000045)=0.127653035038065E+02 gamma(00000045)=0.127653035038065E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 45 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000045)=0.000000000000000E+00 (calc=0.134072287447016E+02 read=0.134072287447016E+02) Weight for this step=-.22457E-01 -.11349E+02 beta (00000046)=0.134072287447016E+02 gamma(00000046)=0.134072287447016E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 46 z1= 1 0.365517339245987E-06 0.000000000000000E+00 z1= 2 -.148311795662823E-05 0.000000000000000E+00 z1= 3 0.699094235000442E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000046)=0.000000000000000E+00 (calc=0.127671169271027E+02 read=0.127671169271027E+02) Weight for this step=-.15751E+00 -.80805E+01 beta (00000047)=0.127671169271027E+02 gamma(00000047)=0.127671169271027E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 47 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000047)=0.000000000000000E+00 (calc=0.133557555202584E+02 read=0.133557555202584E+02) Weight for this step=0.16140E-01 0.11504E+02 beta (00000048)=0.133557555202584E+02 gamma(00000048)=0.133557555202584E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 48 z1= 1 -.360573435163967E-06 0.000000000000000E+00 z1= 2 0.147117097934663E-05 0.000000000000000E+00 z1= 3 -.657702440464821E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000048)=0.000000000000000E+00 (calc=0.128436220916604E+02 read=0.128436220916604E+02) Weight for this step=0.15049E+00 0.82882E+01 beta (00000049)=0.128436220916604E+02 gamma(00000049)=0.128436220916604E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 49 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000049)=0.000000000000000E+00 (calc=0.134358287671511E+02 read=0.134358287671511E+02) Weight for this step=-.97589E-02 -.11540E+02 beta (00000050)=0.134358287671511E+02 gamma(00000050)=0.134358287671511E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 50 z1= 1 0.362310962593736E-06 0.000000000000000E+00 z1= 2 -.145159981269612E-05 0.000000000000000E+00 z1= 3 0.619295188684560E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000050)=0.000000000000000E+00 (calc=0.126967578195664E+02 read=0.126967578195664E+02) Weight for this step=-.14348E+00 -.84851E+01 beta (00000051)=0.126967578195664E+02 gamma(00000051)=0.126967578195664E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 51 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000051)=0.000000000000000E+00 (calc=0.132891101660509E+02 read=0.132891101660509E+02) Weight for this step=0.35981E-02 0.11774E+02 beta (00000052)=0.132891101660509E+02 gamma(00000052)=0.132891101660509E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 52 z1= 1 -.376125630565153E-06 0.000000000000000E+00 z1= 2 0.143060252097026E-05 0.000000000000000E+00 z1= 3 -.582338937991711E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000052)=0.000000000000000E+00 (calc=0.127443381051993E+02 read=0.127443381051993E+02) Weight for this step=0.13637E+00 0.86868E+01 beta (00000053)=0.127443381051993E+02 gamma(00000053)=0.127443381051993E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 53 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000053)=0.000000000000000E+00 (calc=0.133131454589309E+02 read=0.133131454589309E+02) Weight for this step=0.25711E-02 -.11831E+02 beta (00000054)=0.133131454589309E+02 gamma(00000054)=0.133131454589309E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 54 z1= 1 0.386800459106014E-06 0.000000000000000E+00 z1= 2 -.141725972719936E-05 0.000000000000000E+00 z1= 3 0.549116821518537E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000054)=0.000000000000000E+00 (calc=0.127443555249114E+02 read=0.127443555249114E+02) Weight for this step=-.12953E+00 -.88974E+01 beta (00000055)=0.127443555249114E+02 gamma(00000055)=0.127443555249114E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 55 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000055)=0.000000000000000E+00 (calc=0.133785356211157E+02 read=0.133785356211157E+02) Weight for this step=-.86410E-02 0.11902E+02 beta (00000056)=0.133785356211157E+02 gamma(00000056)=0.133785356211157E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 56 z1= 1 -.387040627415299E-06 0.000000000000000E+00 z1= 2 0.140519834988318E-05 0.000000000000000E+00 z1= 3 -.515464356968208E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000056)=0.000000000000000E+00 (calc=0.128320521691373E+02 read=0.128320521691373E+02) Weight for this step=0.12208E+00 0.90580E+01 beta (00000057)=0.128320521691373E+02 gamma(00000057)=0.128320521691373E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 57 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000057)=0.000000000000000E+00 (calc=0.134459831606441E+02 read=0.134459831606441E+02) Weight for this step=0.14531E-01 -.11947E+02 beta (00000058)=0.134459831606441E+02 gamma(00000058)=0.134459831606441E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 58 z1= 1 0.390204114986809E-06 0.000000000000000E+00 z1= 2 -.139598460212201E-05 0.000000000000000E+00 z1= 3 0.484734831516015E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000058)=0.000000000000000E+00 (calc=0.127464099486932E+02 read=0.127464099486932E+02) Weight for this step=-.11491E+00 -.92260E+01 beta (00000059)=0.127464099486932E+02 gamma(00000059)=0.127464099486932E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 59 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000059)=0.000000000000000E+00 (calc=0.133328214749923E+02 read=0.133328214749923E+02) Weight for this step=-.20506E-01 0.12129E+02 beta (00000060)=0.133328214749923E+02 gamma(00000060)=0.133328214749923E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 60 z1= 1 -.401214181003145E-06 0.000000000000000E+00 z1= 2 0.138719729284302E-05 0.000000000000000E+00 z1= 3 -.457064196602605E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000060)=0.000000000000000E+00 (calc=0.128405781829885E+02 read=0.128405781829885E+02) Weight for this step=0.10794E+00 0.94158E+01 beta (00000061)=0.128405781829885E+02 gamma(00000061)=0.128405781829885E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 61 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000061)=0.000000000000000E+00 (calc=0.133760314070602E+02 read=0.133760314070602E+02) Weight for this step=0.26061E-01 -.12114E+02 beta (00000062)=0.133760314070602E+02 gamma(00000062)=0.133760314070602E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 62 z1= 1 0.409863523079257E-06 0.000000000000000E+00 z1= 2 -.138483409732701E-05 0.000000000000000E+00 z1= 3 0.432740700417830E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000062)=0.000000000000000E+00 (calc=0.128441813063261E+02 read=0.128441813063261E+02) Weight for this step=-.10144E+00 -.96317E+01 beta (00000063)=0.128441813063261E+02 gamma(00000063)=0.128441813063261E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 63 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000063)=0.000000000000000E+00 (calc=0.134459529144216E+02 read=0.134459529144216E+02) Weight for this step=-.31560E-01 0.12125E+02 beta (00000064)=0.134459529144216E+02 gamma(00000064)=0.134459529144216E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 64 z1= 1 -.411269645499471E-06 0.000000000000000E+00 z1= 2 0.137674803435417E-05 0.000000000000000E+00 z1= 3 -.408088548818853E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000064)=0.000000000000000E+00 (calc=0.128237659503222E+02 read=0.128237659503222E+02) Weight for this step=0.94458E-01 0.97909E+01 beta (00000065)=0.128237659503222E+02 gamma(00000065)=0.128237659503222E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 65 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000065)=0.000000000000000E+00 (calc=0.134804262353909E+02 read=0.134804262353909E+02) Weight for this step=0.37149E-01 -.12213E+02 beta (00000066)=0.134804262353909E+02 gamma(00000066)=0.134804262353909E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 66 z1= 1 0.407175069250016E-06 0.000000000000000E+00 z1= 2 -.136587456575263E-05 0.000000000000000E+00 z1= 3 0.383603605599958E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000066)=0.000000000000000E+00 (calc=0.128621045321382E+02 read=0.128621045321382E+02) Weight for this step=-.87147E-01 -.99070E+01 beta (00000067)=0.128621045321382E+02 gamma(00000067)=0.128621045321382E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 67 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000067)=0.000000000000000E+00 (calc=0.133881819731300E+02 read=0.133881819731300E+02) Weight for this step=-.42600E-01 0.12296E+02 beta (00000068)=0.133881819731300E+02 gamma(00000068)=0.133881819731300E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 68 z1= 1 -.409205092595402E-06 0.000000000000000E+00 z1= 2 0.136796547267409E-05 0.000000000000000E+00 z1= 3 -.364115422872864E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000068)=0.000000000000000E+00 (calc=0.128152871979624E+02 read=0.128152871979624E+02) Weight for this step=0.80722E-01 0.10119E+02 beta (00000069)=0.128152871979624E+02 gamma(00000069)=0.128152871979624E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 69 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000069)=0.000000000000000E+00 (calc=0.133445169394919E+02 read=0.133445169394919E+02) Weight for this step=0.47838E-01 -.12329E+02 beta (00000070)=0.133445169394919E+02 gamma(00000070)=0.133445169394919E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 70 z1= 1 0.411971292148456E-06 0.000000000000000E+00 z1= 2 -.137035001564320E-05 0.000000000000000E+00 z1= 3 0.345813400894536E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000070)=0.000000000000000E+00 (calc=0.128069664250304E+02 read=0.128069664250304E+02) Weight for this step=-.74250E-01 -.10322E+02 beta (00000071)=0.128069664250304E+02 gamma(00000071)=0.128069664250304E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 71 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000071)=0.000000000000000E+00 (calc=0.134042186544998E+02 read=0.134042186544998E+02) Weight for this step=-.52835E-01 0.12319E+02 beta (00000072)=0.134042186544998E+02 gamma(00000072)=0.134042186544998E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 72 z1= 1 -.408660603338227E-06 0.000000000000000E+00 z1= 2 0.137762322212505E-05 0.000000000000000E+00 z1= 3 -.326970334696585E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000072)=0.000000000000000E+00 (calc=0.128627085061726E+02 read=0.128627085061726E+02) Weight for this step=0.67442E-01 0.10464E+02 beta (00000073)=0.128627085061726E+02 gamma(00000073)=0.128627085061726E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 73 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000073)=0.000000000000000E+00 (calc=0.133230457670377E+02 read=0.133230457670377E+02) Weight for this step=0.57678E-01 -.12305E+02 beta (00000074)=0.133230457670377E+02 gamma(00000074)=0.133230457670377E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 74 z1= 1 0.401753775790725E-06 0.000000000000000E+00 z1= 2 -.139084960749187E-05 0.000000000000000E+00 z1= 3 0.313039437789456E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000074)=0.000000000000000E+00 (calc=0.127141910649933E+02 read=0.127141910649933E+02) Weight for this step=-.61354E-01 -.10707E+02 beta (00000075)=0.127141910649933E+02 gamma(00000075)=0.127141910649933E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 75 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000075)=0.000000000000000E+00 (calc=0.133868811025778E+02 read=0.133868811025778E+02) Weight for this step=-.62757E-01 0.12343E+02 beta (00000076)=0.133868811025778E+02 gamma(00000076)=0.133868811025778E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 76 z1= 1 -.388509971943943E-06 0.000000000000000E+00 z1= 2 0.138194001259636E-05 0.000000000000000E+00 z1= 3 -.294640154357549E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000076)=0.000000000000000E+00 (calc=0.127641729481324E+02 read=0.127641729481324E+02) Weight for this step=0.54281E-01 0.10773E+02 beta (00000077)=0.127641729481324E+02 gamma(00000077)=0.127641729481324E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 77 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000077)=0.000000000000000E+00 (calc=0.133755132283520E+02 read=0.133755132283520E+02) Weight for this step=0.67759E-01 -.12392E+02 beta (00000078)=0.133755132283520E+02 gamma(00000078)=0.133755132283520E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 78 z1= 1 0.375629516454097E-06 0.000000000000000E+00 z1= 2 -.138137834489334E-05 0.000000000000000E+00 z1= 3 0.278749663002037E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000078)=0.000000000000000E+00 (calc=0.128262826897066E+02 read=0.128262826897066E+02) Weight for this step=-.47557E-01 -.10887E+02 beta (00000079)=0.128262826897066E+02 gamma(00000079)=0.128262826897066E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 79 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000079)=0.000000000000000E+00 (calc=0.133316320024586E+02 read=0.133316320024586E+02) Weight for this step=-.72238E-01 0.12367E+02 beta (00000080)=0.133316320024586E+02 gamma(00000080)=0.133316320024586E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 80 z1= 1 -.369271558708093E-06 0.000000000000000E+00 z1= 2 0.138882311198862E-05 0.000000000000000E+00 z1= 3 -.266563623741722E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000080)=0.000000000000000E+00 (calc=0.127857300683316E+02 read=0.127857300683316E+02) Weight for this step=0.41280E-01 0.11081E+02 beta (00000081)=0.127857300683316E+02 gamma(00000081)=0.127857300683316E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 81 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000081)=0.000000000000000E+00 (calc=0.133994468312798E+02 read=0.133994468312798E+02) Weight for this step=0.76569E-01 -.12328E+02 beta (00000082)=0.133994468312798E+02 gamma(00000082)=0.133994468312798E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 82 z1= 1 0.371447025596431E-06 0.000000000000000E+00 z1= 2 -.138006940424298E-05 0.000000000000000E+00 z1= 3 0.253068748144162E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000082)=0.000000000000000E+00 (calc=0.128396974756363E+02 read=0.128396974756363E+02) Weight for this step=-.34728E-01 -.11176E+02 beta (00000083)=0.128396974756363E+02 gamma(00000083)=0.128396974756363E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 83 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000083)=0.000000000000000E+00 (calc=0.133717673234352E+02 read=0.133717673234352E+02) Weight for this step=-.80808E-01 0.12296E+02 beta (00000084)=0.133717673234352E+02 gamma(00000084)=0.133717673234352E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 84 z1= 1 -.374363170708601E-06 0.000000000000000E+00 z1= 2 0.139771086234031E-05 0.000000000000000E+00 z1= 3 -.241734755116356E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000084)=0.000000000000000E+00 (calc=0.128117711412726E+02 read=0.128117711412726E+02) Weight for this step=0.28471E-01 0.11333E+02 beta (00000085)=0.128117711412726E+02 gamma(00000085)=0.128117711412726E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 85 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000085)=0.000000000000000E+00 (calc=0.133218196445265E+02 read=0.133218196445265E+02) Weight for this step=0.84910E-01 -.12254E+02 beta (00000086)=0.133218196445265E+02 gamma(00000086)=0.133218196445265E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 86 z1= 1 0.372583501667776E-06 0.000000000000000E+00 z1= 2 -.140893756512132E-05 0.000000000000000E+00 z1= 3 0.231494824799265E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000086)=0.000000000000000E+00 (calc=0.127545854398070E+02 read=0.127545854398070E+02) Weight for this step=-.22289E-01 -.11501E+02 beta (00000087)=0.127545854398070E+02 gamma(00000087)=0.127545854398070E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 87 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000087)=0.000000000000000E+00 (calc=0.133435650534969E+02 read=0.133435650534969E+02) Weight for this step=-.88928E-01 0.12209E+02 beta (00000088)=0.133435650534969E+02 gamma(00000088)=0.133435650534969E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 88 z1= 1 -.376393157562778E-06 0.000000000000000E+00 z1= 2 0.142932462921156E-05 0.000000000000000E+00 z1= 3 -.220546808921436E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000088)=0.000000000000000E+00 (calc=0.128929928338142E+02 read=0.128929928338142E+02) Weight for this step=0.16028E-01 0.11593E+02 beta (00000089)=0.128929928338142E+02 gamma(00000089)=0.128929928338142E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 89 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000089)=0.000000000000000E+00 (calc=0.133924415621663E+02 read=0.133924415621663E+02) Weight for this step=0.91950E-01 -.12047E+02 beta (00000090)=0.133924415621663E+02 gamma(00000090)=0.133924415621663E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 90 z1= 1 0.379767055989910E-06 0.000000000000000E+00 z1= 2 -.145123236055644E-05 0.000000000000000E+00 z1= 3 0.211836885420150E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000090)=0.000000000000000E+00 (calc=0.126659708940546E+02 read=0.126659708940546E+02) Weight for this step=-.10036E-01 -.11749E+02 beta (00000091)=0.126659708940546E+02 gamma(00000091)=0.126659708940546E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 91 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000091)=0.000000000000000E+00 (calc=0.133458549987805E+02 read=0.133458549987805E+02) Weight for this step=-.96815E-01 0.12131E+02 beta (00000092)=0.133458549987805E+02 gamma(00000092)=0.133458549987805E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 92 z1= 1 -.379719018033702E-06 0.000000000000000E+00 z1= 2 0.143193023750224E-05 0.000000000000000E+00 z1= 3 -.200867510875213E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000092)=0.000000000000000E+00 (calc=0.127909353894367E+02 read=0.127909353894367E+02) Weight for this step=0.38671E-02 0.11746E+02 beta (00000093)=0.127909353894367E+02 gamma(00000093)=0.127909353894367E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 93 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000093)=0.000000000000000E+00 (calc=0.133461392367672E+02 read=0.133461392367672E+02) Weight for this step=0.10030E+00 -.12056E+02 beta (00000094)=0.133461392367672E+02 gamma(00000094)=0.133461392367672E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 94 z1= 1 0.381773205322721E-06 0.000000000000000E+00 z1= 2 -.142332721228642E-05 0.000000000000000E+00 z1= 3 0.192793575825157E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000094)=0.000000000000000E+00 (calc=0.127865756137354E+02 read=0.127865756137354E+02) Weight for this step=0.21164E-02 -.11848E+02 beta (00000095)=0.127865756137354E+02 gamma(00000095)=0.127865756137354E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 95 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000095)=0.000000000000000E+00 (calc=0.133901047924911E+02 read=0.133901047924911E+02) Weight for this step=-.10365E+00 0.11977E+02 beta (00000096)=0.133901047924911E+02 gamma(00000096)=0.133901047924911E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 96 z1= 1 -.382127201856847E-06 0.000000000000000E+00 z1= 2 0.140675853523974E-05 0.000000000000000E+00 z1= 3 -.184173546151282E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000096)=0.000000000000000E+00 (calc=0.127921015489387E+02 read=0.127921015489387E+02) Weight for this step=-.79825E-02 0.11900E+02 beta (00000097)=0.127921015489387E+02 gamma(00000097)=0.127921015489387E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 97 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000097)=0.000000000000000E+00 (calc=0.134509405706367E+02 read=0.134509405706367E+02) Weight for this step=0.10716E+00 -.11928E+02 beta (00000098)=0.134509405706367E+02 gamma(00000098)=0.134509405706367E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 98 z1= 1 0.373403145351647E-06 0.000000000000000E+00 z1= 2 -.138281054593383E-05 0.000000000000000E+00 z1= 3 0.175095013450648E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000098)=0.000000000000000E+00 (calc=0.130150712798412E+02 read=0.130150712798412E+02) Weight for this step=0.13693E-01 -.11897E+02 beta (00000099)=0.130150712798412E+02 gamma(00000099)=0.130150712798412E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 99 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000099)=0.000000000000000E+00 (calc=0.136149151643500E+02 read=0.136149151643500E+02) Weight for this step=-.10914E+00 0.11729E+02 beta (00000100)=0.136149151643500E+02 gamma(00000100)=0.136149151643500E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 100 z1= 1 -.363954833079651E-06 0.000000000000000E+00 z1= 2 0.135140212272154E-05 0.000000000000000E+00 z1= 3 -.167551035958508E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000100)=0.000000000000000E+00 (calc=0.127969537798584E+02 read=0.127969537798584E+02) Weight for this step=-.19199E-01 0.11937E+02 beta (00000101)=0.127969537798584E+02 gamma(00000101)=0.127969537798584E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 101 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000101)=0.000000000000000E+00 (calc=0.132882519555075E+02 read=0.132882519555075E+02) Weight for this step=0.11420E+00 -.11868E+02 beta (00000102)=0.132882519555075E+02 gamma(00000102)=0.132882519555075E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 102 z1= 1 0.353242925780323E-06 0.000000000000000E+00 z1= 2 -.132540844692509E-05 0.000000000000000E+00 z1= 3 0.161802296489767E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000102)=0.000000000000000E+00 (calc=0.128815668818400E+02 read=0.128815668818400E+02) Weight for this step=0.25008E-01 -.12080E+02 beta (00000103)=0.128815668818400E+02 gamma(00000103)=0.128815668818400E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 103 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000103)=0.000000000000000E+00 (calc=0.134147777072236E+02 read=0.134147777072236E+02) Weight for this step=-.11560E+00 0.11629E+02 beta (00000104)=0.134147777072236E+02 gamma(00000104)=0.134147777072236E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 104 z1= 1 -.336068700878081E-06 0.000000000000000E+00 z1= 2 0.130035026413831E-05 0.000000000000000E+00 z1= 3 -.156277973105765E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000104)=0.000000000000000E+00 (calc=0.128778615642414E+02 read=0.128778615642414E+02) Weight for this step=-.30522E-01 0.12168E+02 beta (00000105)=0.128778615642414E+02 gamma(00000105)=0.128778615642414E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 105 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000105)=0.000000000000000E+00 (calc=0.132659081263002E+02 read=0.132659081263002E+02) Weight for this step=0.11792E+00 -.11495E+02 beta (00000106)=0.132659081263002E+02 gamma(00000106)=0.132659081263002E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 106 z1= 1 0.327013289379958E-06 0.000000000000000E+00 z1= 2 -.129753999506975E-05 0.000000000000000E+00 z1= 3 0.152723399666019E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000106)=0.000000000000000E+00 (calc=0.126949443075630E+02 read=0.126949443075630E+02) Weight for this step=0.36314E-01 -.12379E+02 beta (00000107)=0.126949443075630E+02 gamma(00000107)=0.126949443075630E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 107 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000107)=0.000000000000000E+00 (calc=0.133395860015522E+02 read=0.133395860015522E+02) Weight for this step=-.12038E+00 0.11374E+02 beta (00000108)=0.133395860015522E+02 gamma(00000108)=0.133395860015522E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 108 z1= 1 -.308018078545142E-06 0.000000000000000E+00 z1= 2 0.126921008255067E-05 0.000000000000000E+00 z1= 3 -.145903650463620E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000108)=0.000000000000000E+00 (calc=0.128482705661396E+02 read=0.128482705661396E+02) Weight for this step=-.41319E-01 0.12339E+02 beta (00000109)=0.128482705661396E+02 gamma(00000109)=0.128482705661396E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 109 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000109)=0.000000000000000E+00 (calc=0.133217711669384E+02 read=0.133217711669384E+02) Weight for this step=0.12192E+00 -.11180E+02 beta (00000110)=0.133217711669384E+02 gamma(00000110)=0.133217711669384E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 110 z1= 1 0.283648459603245E-06 0.000000000000000E+00 z1= 2 -.124051543318968E-05 0.000000000000000E+00 z1= 3 0.141248766320469E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000110)=0.000000000000000E+00 (calc=0.126967061895085E+02 read=0.126967061895085E+02) Weight for this step=0.46681E-01 -.12450E+02 beta (00000111)=0.126967061895085E+02 gamma(00000111)=0.126967061895085E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 111 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000111)=0.000000000000000E+00 (calc=0.135206935220494E+02 read=0.135206935220494E+02) Weight for this step=-.12453E+00 0.11089E+02 beta (00000112)=0.135206935220494E+02 gamma(00000112)=0.135206935220494E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 112 z1= 1 -.256864003219195E-06 0.000000000000000E+00 z1= 2 0.118176854277090E-05 0.000000000000000E+00 z1= 3 -.133230978099493E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000112)=0.000000000000000E+00 (calc=0.129787454282089E+02 read=0.129787454282089E+02) Weight for this step=-.50685E-01 0.12228E+02 beta (00000113)=0.129787454282089E+02 gamma(00000113)=0.129787454282089E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 113 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000113)=0.000000000000000E+00 (calc=0.134372012459742E+02 read=0.134372012459742E+02) Weight for this step=0.12623E+00 -.10935E+02 beta (00000114)=0.134372012459742E+02 gamma(00000114)=0.134372012459742E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 114 z1= 1 0.244636859705861E-06 0.000000000000000E+00 z1= 2 -.115227036997167E-05 0.000000000000000E+00 z1= 3 0.129013752388221E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000114)=0.000000000000000E+00 (calc=0.127033496681572E+02 read=0.127033496681572E+02) Weight for this step=0.55919E-01 -.12343E+02 beta (00000115)=0.127033496681572E+02 gamma(00000115)=0.127033496681572E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 115 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000115)=0.000000000000000E+00 (calc=0.135069865158704E+02 read=0.135069865158704E+02) Weight for this step=-.12967E+00 0.10931E+02 beta (00000116)=0.135069865158704E+02 gamma(00000116)=0.135069865158704E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 116 z1= 1 -.219912628478952E-06 0.000000000000000E+00 z1= 2 0.108452654905682E-05 0.000000000000000E+00 z1= 3 -.122157825431331E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000116)=0.000000000000000E+00 (calc=0.127083383061776E+02 read=0.127083383061776E+02) Weight for this step=-.59686E-01 0.12139E+02 beta (00000117)=0.127083383061776E+02 gamma(00000117)=0.127083383061776E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 117 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000117)=0.000000000000000E+00 (calc=0.132506521961417E+02 read=0.132506521961417E+02) Weight for this step=0.13379E+00 -.10992E+02 beta (00000118)=0.132506521961417E+02 gamma(00000118)=0.132506521961417E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 118 z1= 1 0.200016961818294E-06 0.000000000000000E+00 z1= 2 -.103772241404358E-05 0.000000000000000E+00 z1= 3 0.118300356893247E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000118)=0.000000000000000E+00 (calc=0.127948297849974E+02 read=0.127948297849974E+02) Weight for this step=0.64682E-01 -.12185E+02 beta (00000119)=0.127948297849974E+02 gamma(00000119)=0.127948297849974E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 119 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000119)=0.000000000000000E+00 (calc=0.133198414949376E+02 read=0.133198414949376E+02) Weight for this step=-.13430E+00 0.10760E+02 beta (00000120)=0.133198414949376E+02 gamma(00000120)=0.133198414949376E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 120 z1= 1 -.179696860330453E-06 0.000000000000000E+00 z1= 2 0.995052870292345E-06 0.000000000000000E+00 z1= 3 -.114618197098762E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000120)=0.000000000000000E+00 (calc=0.125251037201406E+02 read=0.125251037201406E+02) Weight for this step=-.69540E-01 0.12233E+02 beta (00000121)=0.125251037201406E+02 gamma(00000121)=0.125251037201406E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 121 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000121)=0.000000000000000E+00 (calc=0.131931004350965E+02 read=0.131931004350965E+02) Weight for this step=0.13821E+00 -.10804E+02 beta (00000122)=0.131931004350965E+02 gamma(00000122)=0.131931004350965E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 122 z1= 1 0.157050003878187E-06 0.000000000000000E+00 z1= 2 -.936636090655130E-06 0.000000000000000E+00 z1= 3 0.109870704163155E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000122)=0.000000000000000E+00 (calc=0.127053179605588E+02 read=0.127053179605588E+02) Weight for this step=0.73696E-01 -.12150E+02 beta (00000123)=0.127053179605588E+02 gamma(00000123)=0.127053179605588E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 123 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000123)=0.000000000000000E+00 (calc=0.133819583568168E+02 read=0.133819583568168E+02) Weight for this step=-.13876E+00 0.10593E+02 beta (00000124)=0.133819583568168E+02 gamma(00000124)=0.133819583568168E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 124 z1= 1 -.145357734462014E-06 0.000000000000000E+00 z1= 2 0.868061269802714E-06 0.000000000000000E+00 z1= 3 -.105066557291688E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000124)=0.000000000000000E+00 (calc=0.126842085207324E+02 read=0.126842085207324E+02) Weight for this step=-.77549E-01 0.12054E+02 beta (00000125)=0.126842085207324E+02 gamma(00000125)=0.126842085207324E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 125 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000125)=0.000000000000000E+00 (calc=0.133805649366138E+02 read=0.133805649366138E+02) Weight for this step=0.14144E+00 -.10553E+02 beta (00000126)=0.133805649366138E+02 gamma(00000126)=0.133805649366138E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 126 z1= 1 0.130462991909094E-06 0.000000000000000E+00 z1= 2 -.800554829065415E-06 0.000000000000000E+00 z1= 3 0.100410644616621E-01 0.000000000000000E+00 Calculating total response charge density alpha(00000126)=0.000000000000000E+00 (calc=0.128061227389666E+02 read=0.128061227389666E+02) Weight for this step=0.81221E-01 -.11943E+02 beta (00000127)=0.128061227389666E+02 gamma(00000127)=0.128061227389666E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 127 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000127)=0.000000000000000E+00 (calc=0.132907868245130E+02 read=0.132907868245130E+02) Weight for this step=-.14270E+00 0.10416E+02 beta (00000128)=0.132907868245130E+02 gamma(00000128)=0.132907868245130E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 128 z1= 1 -.108976730496633E-06 0.000000000000000E+00 z1= 2 0.745894295548931E-06 0.000000000000000E+00 z1= 3 -.973689132445747E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000128)=0.000000000000000E+00 (calc=0.127747959183102E+02 read=0.127747959183102E+02) Weight for this step=-.86071E-01 0.12020E+02 beta (00000129)=0.127747959183102E+02 gamma(00000129)=0.127747959183102E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 129 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000129)=0.000000000000000E+00 (calc=0.132951242339266E+02 read=0.132951242339266E+02) Weight for this step=0.14311E+00 -.10221E+02 beta (00000130)=0.132951242339266E+02 gamma(00000130)=0.132951242339266E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 130 z1= 1 0.920587140817043E-07 0.000000000000000E+00 z1= 2 -.677405282911215E-06 0.000000000000000E+00 z1= 3 0.941492002019327E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000130)=0.000000000000000E+00 (calc=0.127446363909353E+02 read=0.127446363909353E+02) Weight for this step=0.90518E-01 -.12053E+02 beta (00000131)=0.127446363909353E+02 gamma(00000131)=0.127446363909353E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 131 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000131)=0.000000000000000E+00 (calc=0.131433407621370E+02 read=0.131433407621370E+02) Weight for this step=-.14370E+00 0.10043E+02 beta (00000132)=0.131433407621370E+02 gamma(00000132)=0.131433407621370E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 132 z1= 1 -.716042326161237E-07 0.000000000000000E+00 z1= 2 0.604217574758906E-06 0.000000000000000E+00 z1= 3 -.917833925590113E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000132)=0.000000000000000E+00 (calc=0.127576269161865E+02 read=0.127576269161865E+02) Weight for this step=-.95693E-01 0.12188E+02 beta (00000133)=0.127576269161865E+02 gamma(00000133)=0.127576269161865E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 133 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000133)=0.000000000000000E+00 (calc=0.134670396248101E+02 read=0.134670396248101E+02) Weight for this step=0.14218E+00 -.97217E+01 beta (00000134)=0.134670396248101E+02 gamma(00000134)=0.134670396248101E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 134 z1= 1 0.500940044599520E-07 0.000000000000000E+00 z1= 2 -.518604529950158E-06 0.000000000000000E+00 z1= 3 0.869379152367554E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000134)=0.000000000000000E+00 (calc=0.127762096765290E+02 read=0.127762096765290E+02) Weight for this step=0.98285E-01 -.12018E+02 beta (00000135)=0.127762096765290E+02 gamma(00000135)=0.127762096765290E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 135 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000135)=0.000000000000000E+00 (calc=0.134260243123721E+02 read=0.134260243123721E+02) Weight for this step=-.14389E+00 0.96317E+01 beta (00000136)=0.134260243123721E+02 gamma(00000136)=0.134260243123721E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 136 z1= 1 -.282748881853551E-07 0.000000000000000E+00 z1= 2 0.433753171752383E-06 0.000000000000000E+00 z1= 3 -.830339421216032E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000136)=0.000000000000000E+00 (calc=0.129114138411252E+02 read=0.129114138411252E+02) Weight for this step=-.10126E+00 0.11906E+02 beta (00000137)=0.129114138411252E+02 gamma(00000137)=0.129114138411252E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 137 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000137)=0.000000000000000E+00 (calc=0.133836428113206E+02 read=0.133836428113206E+02) Weight for this step=0.14357E+00 -.94119E+01 beta (00000138)=0.133836428113206E+02 gamma(00000138)=0.133836428113206E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 138 z1= 1 0.210099656530911E-08 0.000000000000000E+00 z1= 2 -.364009318607747E-06 0.000000000000000E+00 z1= 3 0.809097097954074E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000138)=0.000000000000000E+00 (calc=0.129445226704384E+02 read=0.129445226704384E+02) Weight for this step=0.10541E+00 -.11946E+02 beta (00000139)=0.129445226704384E+02 gamma(00000139)=0.129445226704384E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 139 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000139)=0.000000000000000E+00 (calc=0.135471024985667E+02 read=0.135471024985667E+02) Weight for this step=-.14219E+00 0.91271E+01 beta (00000140)=0.135471024985667E+02 gamma(00000140)=0.135471024985667E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 140 z1= 1 0.154140975646344E-07 0.000000000000000E+00 z1= 2 0.296632525290797E-06 0.000000000000000E+00 z1= 3 -.782250478209451E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000140)=0.000000000000000E+00 (calc=0.127278446741130E+02 read=0.127278446741130E+02) Weight for this step=-.10827E+00 0.11856E+02 beta (00000141)=0.127278446741130E+02 gamma(00000141)=0.127278446741130E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 141 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000141)=0.000000000000000E+00 (calc=0.134909264708063E+02 read=0.134909264708063E+02) Weight for this step=0.14484E+00 -.91049E+01 beta (00000142)=0.134909264708063E+02 gamma(00000142)=0.134909264708063E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 142 z1= 1 -.426478923307248E-07 0.000000000000000E+00 z1= 2 -.211168451976613E-06 0.000000000000000E+00 z1= 3 0.747283926774506E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000142)=0.000000000000000E+00 (calc=0.127388148861879E+02 read=0.127388148861879E+02) Weight for this step=0.10985E+00 -.11627E+02 beta (00000143)=0.127388148861879E+02 gamma(00000143)=0.127388148861879E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 143 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000143)=0.000000000000000E+00 (calc=0.134409885814349E+02 read=0.134409885814349E+02) Weight for this step=-.14683E+00 0.90449E+01 beta (00000144)=0.134409885814349E+02 gamma(00000144)=0.134409885814349E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 144 z1= 1 0.747484597842484E-07 0.000000000000000E+00 z1= 2 0.144201699034879E-06 0.000000000000000E+00 z1= 3 -.715012006305781E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000144)=0.000000000000000E+00 (calc=0.129263333353800E+02 read=0.129263333353800E+02) Weight for this step=-.11193E+00 0.11460E+02 beta (00000145)=0.129263333353800E+02 gamma(00000145)=0.129263333353800E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 145 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000145)=0.000000000000000E+00 (calc=0.133955255823472E+02 read=0.133955255823472E+02) Weight for this step=0.14613E+00 -.88247E+01 beta (00000146)=0.133955255823472E+02 gamma(00000146)=0.133955255823472E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 146 z1= 1 -.106416011726954E-06 0.000000000000000E+00 z1= 2 -.825984373834052E-07 0.000000000000000E+00 z1= 3 0.694954061214565E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000146)=0.000000000000000E+00 (calc=0.128294728964879E+02 read=0.128294728964879E+02) Weight for this step=0.11581E+00 -.11490E+02 beta (00000147)=0.128294728964879E+02 gamma(00000147)=0.128294728964879E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 147 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000147)=0.000000000000000E+00 (calc=0.136375244342276E+02 read=0.136375244342276E+02) Weight for this step=-.14577E+00 0.86278E+01 beta (00000148)=0.136375244342276E+02 gamma(00000148)=0.136375244342276E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 148 z1= 1 0.143486239325254E-06 0.000000000000000E+00 z1= 2 0.312285877524052E-07 0.000000000000000E+00 z1= 3 -.656989240948941E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000148)=0.000000000000000E+00 (calc=0.127202999421697E+02 read=0.127202999421697E+02) Weight for this step=-.11658E+00 0.11223E+02 beta (00000149)=0.127202999421697E+02 gamma(00000149)=0.127202999421697E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 149 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000149)=0.000000000000000E+00 (calc=0.135407524599554E+02 read=0.135407524599554E+02) Weight for this step=0.14940E+00 -.86724E+01 beta (00000150)=0.135407524599554E+02 gamma(00000150)=0.135407524599554E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 150 z1= 1 -.176464841550512E-06 0.000000000000000E+00 z1= 2 0.294639030420886E-07 0.000000000000000E+00 z1= 3 0.618160732530675E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000150)=0.000000000000000E+00 (calc=0.126679029120049E+02 read=0.126679029120049E+02) Weight for this step=0.11738E+00 -.10963E+02 beta (00000151)=0.126679029120049E+02 gamma(00000151)=0.126679029120049E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 151 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000151)=0.000000000000000E+00 (calc=0.134957589029234E+02 read=0.134957589029234E+02) Weight for this step=-.15276E+00 0.87035E+01 beta (00000152)=0.134957589029234E+02 gamma(00000152)=0.134957589029234E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 152 z1= 1 0.207635163850233E-06 0.000000000000000E+00 z1= 2 -.828628765221773E-07 0.000000000000000E+00 z1= 3 -.579888942995532E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000152)=0.000000000000000E+00 (calc=0.125471926645662E+02 read=0.125471926645662E+02) Weight for this step=-.11823E+00 0.10712E+02 beta (00000153)=0.125471926645662E+02 gamma(00000153)=0.125471926645662E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 153 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000153)=0.000000000000000E+00 (calc=0.132884937185102E+02 read=0.132884937185102E+02) Weight for this step=0.15729E+00 -.88026E+01 beta (00000154)=0.132884937185102E+02 gamma(00000154)=0.132884937185102E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 154 z1= 1 -.241500095632115E-06 0.000000000000000E+00 z1= 2 0.142512180870049E-06 0.000000000000000E+00 z1= 3 0.545223355858780E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000154)=0.000000000000000E+00 (calc=0.128413078290597E+02 read=0.128413078290597E+02) Weight for this step=0.12005E+00 -.10548E+02 beta (00000155)=0.128413078290597E+02 gamma(00000155)=0.128413078290597E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 155 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000155)=0.000000000000000E+00 (calc=0.133879541207903E+02 read=0.133879541207903E+02) Weight for this step=-.15582E+00 0.85715E+01 beta (00000156)=0.133879541207903E+02 gamma(00000156)=0.133879541207903E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 156 z1= 1 0.269820176843224E-06 0.000000000000000E+00 z1= 2 -.195535615146129E-06 0.000000000000000E+00 z1= 3 -.518984216730662E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000156)=0.000000000000000E+00 (calc=0.128086777078369E+02 read=0.128086777078369E+02) Weight for this step=-.12341E+00 0.10537E+02 beta (00000157)=0.128086777078369E+02 gamma(00000157)=0.128086777078369E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 157 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000157)=0.000000000000000E+00 (calc=0.135343396812008E+02 read=0.135343396812008E+02) Weight for this step=0.15574E+00 -.84206E+01 beta (00000158)=0.135343396812008E+02 gamma(00000158)=0.135343396812008E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 158 z1= 1 -.298275948794335E-06 0.000000000000000E+00 z1= 2 0.248966304255581E-06 0.000000000000000E+00 z1= 3 0.482114624317746E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000158)=0.000000000000000E+00 (calc=0.127047568736182E+02 read=0.127047568736182E+02) Weight for this step=0.12494E+00 -.10379E+02 beta (00000159)=0.127047568736182E+02 gamma(00000159)=0.127047568736182E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 159 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000159)=0.000000000000000E+00 (calc=0.132659525194084E+02 read=0.132659525194084E+02) Weight for this step=-.15866E+00 0.84357E+01 beta (00000160)=0.132659525194084E+02 gamma(00000160)=0.132659525194084E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 160 z1= 1 0.326041822706034E-06 0.000000000000000E+00 z1= 2 -.313547989584098E-06 0.000000000000000E+00 z1= 3 -.451845186124902E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000160)=0.000000000000000E+00 (calc=0.125635456867439E+02 read=0.125635456867439E+02) Weight for this step=-.12812E+00 0.10356E+02 beta (00000161)=0.125635456867439E+02 gamma(00000161)=0.125635456867439E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 161 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000161)=0.000000000000000E+00 (calc=0.133039633284584E+02 read=0.133039633284584E+02) Weight for this step=0.16003E+00 -.83678E+01 beta (00000162)=0.133039633284584E+02 gamma(00000162)=0.133039633284584E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 162 z1= 1 -.341117347757002E-06 0.000000000000000E+00 z1= 2 0.380000502966585E-06 0.000000000000000E+00 z1= 3 0.423000653483744E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000162)=0.000000000000000E+00 (calc=0.127495020522159E+02 read=0.127495020522159E+02) Weight for this step=0.12949E+00 -.10191E+02 beta (00000163)=0.127495020522159E+02 gamma(00000163)=0.127495020522159E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 163 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000163)=0.000000000000000E+00 (calc=0.131751256591847E+02 read=0.131751256591847E+02) Weight for this step=-.15954E+00 0.82084E+01 beta (00000164)=0.131751256591847E+02 gamma(00000164)=0.131751256591847E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 164 z1= 1 0.358750322765432E-06 0.000000000000000E+00 z1= 2 -.447155730302288E-06 0.000000000000000E+00 z1= 3 -.411031749346049E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000164)=0.000000000000000E+00 (calc=0.126038904677211E+02 read=0.126038904677211E+02) Weight for this step=-.13386E+00 0.10270E+02 beta (00000165)=0.126038904677211E+02 gamma(00000165)=0.126038904677211E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 165 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000165)=0.000000000000000E+00 (calc=0.134358653971800E+02 read=0.134358653971800E+02) Weight for this step=0.15900E+00 -.80471E+01 beta (00000166)=0.134358653971800E+02 gamma(00000166)=0.134358653971800E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 166 z1= 1 -.363865760978638E-06 0.000000000000000E+00 z1= 2 0.491400649710164E-06 0.000000000000000E+00 z1= 3 0.389753150249627E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000166)=0.000000000000000E+00 (calc=0.127184584998628E+02 read=0.127184584998628E+02) Weight for this step=0.13392E+00 -.10026E+02 beta (00000167)=0.127184584998628E+02 gamma(00000167)=0.127184584998628E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 167 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000167)=0.000000000000000E+00 (calc=0.134466489192027E+02 read=0.134466489192027E+02) Weight for this step=-.16029E+00 0.79850E+01 beta (00000168)=0.134466489192027E+02 gamma(00000168)=0.134466489192027E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 168 z1= 1 0.375224016277962E-06 0.000000000000000E+00 z1= 2 -.530232530982286E-06 0.000000000000000E+00 z1= 3 -.379403085737479E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000168)=0.000000000000000E+00 (calc=0.127723884691224E+02 read=0.127723884691224E+02) Weight for this step=-.13506E+00 0.98719E+01 beta (00000169)=0.127723884691224E+02 gamma(00000169)=0.127723884691224E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 169 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000169)=0.000000000000000E+00 (calc=0.132923318105464E+02 read=0.132923318105464E+02) Weight for this step=0.16106E+00 -.79006E+01 beta (00000170)=0.132923318105464E+02 gamma(00000170)=0.132923318105464E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 170 z1= 1 -.391443385787480E-06 0.000000000000000E+00 z1= 2 0.577785297559461E-06 0.000000000000000E+00 z1= 3 0.375438362727501E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000170)=0.000000000000000E+00 (calc=0.127568566893478E+02 read=0.127568566893478E+02) Weight for this step=0.13830E+00 -.98748E+01 beta (00000171)=0.127568566893478E+02 gamma(00000171)=0.127568566893478E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 171 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000171)=0.000000000000000E+00 (calc=0.133681883094181E+02 read=0.133681883094181E+02) Weight for this step=-.15994E+00 0.77255E+01 beta (00000172)=0.133681883094181E+02 gamma(00000172)=0.133681883094181E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 172 z1= 1 0.411371150653038E-06 0.000000000000000E+00 z1= 2 -.634873761258612E-06 0.000000000000000E+00 z1= 3 -.371256942782182E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000172)=0.000000000000000E+00 (calc=0.127960417302967E+02 read=0.127960417302967E+02) Weight for this step=-.14039E+00 0.98015E+01 beta (00000173)=0.127960417302967E+02 gamma(00000173)=0.127960417302967E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 173 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000173)=0.000000000000000E+00 (calc=0.134741900471903E+02 read=0.134741900471903E+02) Weight for this step=0.15915E+00 -.75695E+01 beta (00000174)=0.134741900471903E+02 gamma(00000174)=0.134741900471903E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 174 z1= 1 -.421300142582813E-06 0.000000000000000E+00 z1= 2 0.681455693916537E-06 0.000000000000000E+00 z1= 3 0.357095407250748E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000174)=0.000000000000000E+00 (calc=0.128361178481879E+02 read=0.128361178481879E+02) Weight for this step=0.14162E+00 -.96759E+01 beta (00000175)=0.128361178481879E+02 gamma(00000175)=0.128361178481879E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 175 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000175)=0.000000000000000E+00 (calc=0.133955772904282E+02 read=0.133955772904282E+02) Weight for this step=-.15908E+00 0.74524E+01 beta (00000176)=0.133955772904282E+02 gamma(00000176)=0.133955772904282E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 176 z1= 1 0.437586844400327E-06 0.000000000000000E+00 z1= 2 -.739431561178728E-06 0.000000000000000E+00 z1= 3 -.335493395881408E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000176)=0.000000000000000E+00 (calc=0.127371820873151E+02 read=0.127371820873151E+02) Weight for this step=-.14403E+00 0.96360E+01 beta (00000177)=0.127371820873151E+02 gamma(00000177)=0.127371820873151E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 177 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000177)=0.000000000000000E+00 (calc=0.133609367412272E+02 read=0.133609367412272E+02) Weight for this step=0.15915E+00 -.73424E+01 beta (00000178)=0.133609367412272E+02 gamma(00000178)=0.133609367412272E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 178 z1= 1 -.455401051569973E-06 0.000000000000000E+00 z1= 2 0.791255630966630E-06 0.000000000000000E+00 z1= 3 0.312199236370041E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000178)=0.000000000000000E+00 (calc=0.126228648204348E+02 read=0.126228648204348E+02) Weight for this step=0.14566E+00 -.95459E+01 beta (00000179)=0.126228648204348E+02 gamma(00000179)=0.126228648204348E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 179 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000179)=0.000000000000000E+00 (calc=0.134189388232718E+02 read=0.134189388232718E+02) Weight for this step=-.16014E+00 0.72767E+01 beta (00000180)=0.134189388232718E+02 gamma(00000180)=0.134189388232718E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 180 z1= 1 0.470850843370694E-06 0.000000000000000E+00 z1= 2 -.847009135181652E-06 0.000000000000000E+00 z1= 3 -.280504011437932E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000180)=0.000000000000000E+00 (calc=0.127642324869603E+02 read=0.127642324869603E+02) Weight for this step=-.14537E+00 0.93345E+01 beta (00000181)=0.127642324869603E+02 gamma(00000181)=0.127642324869603E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 181 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000181)=0.000000000000000E+00 (calc=0.134409155381448E+02 read=0.134409155381448E+02) Weight for this step=0.16017E+00 -.71712E+01 beta (00000182)=0.134409155381448E+02 gamma(00000182)=0.134409155381448E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 182 z1= 1 -.495732831673479E-06 0.000000000000000E+00 z1= 2 0.910779302113173E-06 0.000000000000000E+00 z1= 3 0.252769582888933E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000182)=0.000000000000000E+00 (calc=0.128179032870292E+02 read=0.128179032870292E+02) Weight for this step=0.14638E+00 -.92138E+01 beta (00000183)=0.128179032870292E+02 gamma(00000183)=0.128179032870292E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 183 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000183)=0.000000000000000E+00 (calc=0.135090379866188E+02 read=0.135090379866188E+02) Weight for this step=-.15976E+00 0.70492E+01 beta (00000184)=0.135090379866188E+02 gamma(00000184)=0.135090379866188E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 184 z1= 1 0.506313380926621E-06 0.000000000000000E+00 z1= 2 -.984229772027783E-06 0.000000000000000E+00 z1= 3 -.229157542438511E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000184)=0.000000000000000E+00 (calc=0.129152257419814E+02 read=0.129152257419814E+02) Weight for this step=-.14716E+00 0.90840E+01 beta (00000185)=0.129152257419814E+02 gamma(00000185)=0.129152257419814E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 185 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000185)=0.000000000000000E+00 (calc=0.133109443733883E+02 read=0.133109443733883E+02) Weight for this step=0.15895E+00 -.69129E+01 beta (00000186)=0.133109443733883E+02 gamma(00000186)=0.133109443733883E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 186 z1= 1 -.524543938966524E-06 0.000000000000000E+00 z1= 2 0.107143643765241E-05 0.000000000000000E+00 z1= 3 0.208359555710289E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000186)=0.000000000000000E+00 (calc=0.127266789412962E+02 read=0.127266789412962E+02) Weight for this step=0.15112E+00 -.91539E+01 beta (00000187)=0.127266789412962E+02 gamma(00000187)=0.127266789412962E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 187 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000187)=0.000000000000000E+00 (calc=0.134537882668055E+02 read=0.134537882668055E+02) Weight for this step=-.15775E+00 0.67595E+01 beta (00000188)=0.134537882668055E+02 gamma(00000188)=0.134537882668055E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 188 z1= 1 0.531954343362798E-06 0.000000000000000E+00 z1= 2 -.113341419523476E-05 0.000000000000000E+00 z1= 3 -.185796104338828E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000188)=0.000000000000000E+00 (calc=0.129513184374789E+02 read=0.129513184374789E+02) Weight for this step=-.15113E+00 0.89880E+01 beta (00000189)=0.129513184374789E+02 gamma(00000189)=0.129513184374789E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 189 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000189)=0.000000000000000E+00 (calc=0.137067231672941E+02 read=0.137067231672941E+02) Weight for this step=0.15554E+00 -.65674E+01 beta (00000190)=0.137067231672941E+02 gamma(00000190)=0.137067231672941E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 190 z1= 1 -.531471382116987E-06 0.000000000000000E+00 z1= 2 0.116532745453107E-05 0.000000000000000E+00 z1= 3 0.163472147117292E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000190)=0.000000000000000E+00 (calc=0.128651888494620E+02 read=0.128651888494620E+02) Weight for this step=0.15071E+00 -.88063E+01 beta (00000191)=0.128651888494620E+02 gamma(00000191)=0.128651888494620E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 191 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000191)=0.000000000000000E+00 (calc=0.134373747764514E+02 read=0.134373747764514E+02) Weight for this step=-.15736E+00 0.65490E+01 beta (00000192)=0.134373747764514E+02 gamma(00000192)=0.134373747764514E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 192 z1= 1 0.542032768081592E-06 0.000000000000000E+00 z1= 2 -.121409514990936E-05 0.000000000000000E+00 z1= 3 -.143887773699323E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000192)=0.000000000000000E+00 (calc=0.127839033456557E+02 read=0.127839033456557E+02) Weight for this step=-.15244E+00 0.87503E+01 beta (00000193)=0.127839033456557E+02 gamma(00000193)=0.127839033456557E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 193 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000193)=0.000000000000000E+00 (calc=0.131981242319597E+02 read=0.131981242319597E+02) Weight for this step=0.15691E+00 -.64357E+01 beta (00000194)=0.131981242319597E+02 gamma(00000194)=0.131981242319597E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 194 z1= 1 -.554376804885628E-06 0.000000000000000E+00 z1= 2 0.127172951957448E-05 0.000000000000000E+00 z1= 3 0.131551717073916E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000194)=0.000000000000000E+00 (calc=0.126839705637911E+02 read=0.126839705637911E+02) Weight for this step=0.15593E+00 -.87949E+01 beta (00000195)=0.126839705637911E+02 gamma(00000195)=0.126839705637911E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 195 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000195)=0.000000000000000E+00 (calc=0.133139870616707E+02 read=0.133139870616707E+02) Weight for this step=-.15453E+00 0.62427E+01 beta (00000196)=0.133139870616707E+02 gamma(00000196)=0.133139870616707E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 196 z1= 1 0.558486781600546E-06 0.000000000000000E+00 z1= 2 -.131997583286021E-05 0.000000000000000E+00 z1= 3 -.121598765817174E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000196)=0.000000000000000E+00 (calc=0.126079556710371E+02 read=0.126079556710371E+02) Weight for this step=-.15662E+00 0.86856E+01 beta (00000197)=0.126079556710371E+02 gamma(00000197)=0.126079556710371E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 197 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000197)=0.000000000000000E+00 (calc=0.136343170438687E+02 read=0.136343170438687E+02) Weight for this step=0.15437E+00 -.61413E+01 beta (00000198)=0.136343170438687E+02 gamma(00000198)=0.136343170438687E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 198 z1= 1 -.543820786502565E-06 0.000000000000000E+00 z1= 2 0.131330038152051E-05 0.000000000000000E+00 z1= 3 0.114361442906076E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000198)=0.000000000000000E+00 (calc=0.126706279852249E+02 read=0.126706279852249E+02) Weight for this step=0.15269E+00 -.83267E+01 beta (00000199)=0.126706279852249E+02 gamma(00000199)=0.126706279852249E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 199 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000199)=0.000000000000000E+00 (calc=0.134978626881212E+02 read=0.134978626881212E+02) Weight for this step=-.15756E+00 0.61782E+01 beta (00000200)=0.134978626881212E+02 gamma(00000200)=0.134978626881212E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 200 z1= 1 0.546122877799971E-06 0.000000000000000E+00 z1= 2 -.133728157675694E-05 0.000000000000000E+00 z1= 3 -.113919605987403E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000200)=0.000000000000000E+00 (calc=0.126143139102749E+02 read=0.126143139102749E+02) Weight for this step=-.15143E+00 0.81160E+01 beta (00000201)=0.126143139102749E+02 gamma(00000201)=0.126143139102749E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 201 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000201)=0.000000000000000E+00 (calc=0.133826811062926E+02 read=0.133826811062926E+02) Weight for this step=0.16009E+00 -.61898E+01 beta (00000202)=0.133826811062926E+02 gamma(00000202)=0.133826811062926E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 202 z1= 1 -.550805676898203E-06 0.000000000000000E+00 z1= 2 0.133621853515861E-05 0.000000000000000E+00 z1= 3 0.113993346498625E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000202)=0.000000000000000E+00 (calc=0.127737846541513E+02 read=0.127737846541513E+02) Weight for this step=0.15103E+00 -.79527E+01 beta (00000203)=0.127737846541513E+02 gamma(00000203)=0.127737846541513E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 203 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000203)=0.000000000000000E+00 (calc=0.135575587079049E+02 read=0.135575587079049E+02) Weight for this step=-.15936E+00 0.60773E+01 beta (00000204)=0.135575587079049E+02 gamma(00000204)=0.135575587079049E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 204 z1= 1 0.552442015003528E-06 0.000000000000000E+00 z1= 2 -.134429945664795E-05 0.000000000000000E+00 z1= 3 -.112070105984679E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000204)=0.000000000000000E+00 (calc=0.128450518769431E+02 read=0.128450518769431E+02) Weight for this step=-.15044E+00 0.77864E+01 beta (00000205)=0.128450518769431E+02 gamma(00000205)=0.128450518769431E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 205 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000205)=0.000000000000000E+00 (calc=0.134791534801382E+02 read=0.134791534801382E+02) Weight for this step=0.15993E+00 -.60177E+01 beta (00000206)=0.134791534801382E+02 gamma(00000206)=0.134791534801382E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 206 z1= 1 -.563934132017074E-06 0.000000000000000E+00 z1= 2 0.133887510243299E-05 0.000000000000000E+00 z1= 3 0.117526056168665E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000206)=0.000000000000000E+00 (calc=0.127620203992589E+02 read=0.127620203992589E+02) Weight for this step=0.15158E+00 -.77123E+01 beta (00000207)=0.127620203992589E+02 gamma(00000207)=0.127620203992589E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 207 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000207)=0.000000000000000E+00 (calc=0.133839137319547E+02 read=0.133839137319547E+02) Weight for this step=-.16054E+00 0.59602E+01 beta (00000208)=0.133839137319547E+02 gamma(00000208)=0.133839137319547E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 208 z1= 1 0.574977857099369E-06 0.000000000000000E+00 z1= 2 -.133677040462204E-05 0.000000000000000E+00 z1= 3 -.125150370437088E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000208)=0.000000000000000E+00 (calc=0.126287971377642E+02 read=0.126287971377642E+02) Weight for this step=-.15283E+00 0.76455E+01 beta (00000209)=0.126287971377642E+02 gamma(00000209)=0.126287971377642E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 209 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000209)=0.000000000000000E+00 (calc=0.135242410449407E+02 read=0.135242410449407E+02) Weight for this step=0.16161E+00 -.59203E+01 beta (00000210)=0.135242410449407E+02 gamma(00000210)=0.135242410449407E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 210 z1= 1 -.570969557827771E-06 0.000000000000000E+00 z1= 2 0.130803923326122E-05 0.000000000000000E+00 z1= 3 0.133352042792105E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000210)=0.000000000000000E+00 (calc=0.126503303340757E+02 read=0.126503303340757E+02) Weight for this step=0.15097E+00 -.74258E+01 beta (00000211)=0.126503303340757E+02 gamma(00000211)=0.126503303340757E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 211 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000211)=0.000000000000000E+00 (calc=0.135864385904648E+02 read=0.135864385904648E+02) Weight for this step=-.16438E+00 0.59451E+01 beta (00000212)=0.135864385904648E+02 gamma(00000212)=0.135864385904648E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 212 z1= 1 0.565673003581120E-06 0.000000000000000E+00 z1= 2 -.129390056143031E-05 0.000000000000000E+00 z1= 3 -.134124387012651E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000212)=0.000000000000000E+00 (calc=0.126859743538517E+02 read=0.126859743538517E+02) Weight for this step=-.14893E+00 0.72006E+01 beta (00000213)=0.126859743538517E+02 gamma(00000213)=0.126859743538517E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 213 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000213)=0.000000000000000E+00 (calc=0.134727079869596E+02 read=0.134727079869596E+02) Weight for this step=0.16779E+00 -.59955E+01 beta (00000214)=0.134727079869596E+02 gamma(00000214)=0.134727079869596E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 214 z1= 1 -.570099732002065E-06 0.000000000000000E+00 z1= 2 0.130798919853949E-05 0.000000000000000E+00 z1= 3 0.124212549145008E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000214)=0.000000000000000E+00 (calc=0.125567667102425E+02 read=0.125567667102425E+02) Weight for this step=0.14883E+00 -.70714E+01 beta (00000215)=0.125567667102425E+02 gamma(00000215)=0.125567667102425E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 215 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000215)=0.000000000000000E+00 (calc=0.132488415349025E+02 read=0.132488415349025E+02) Weight for this step=-.17171E+00 0.60642E+01 beta (00000216)=0.132488415349025E+02 gamma(00000216)=0.132488415349025E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 216 z1= 1 0.573717353576290E-06 0.000000000000000E+00 z1= 2 -.131334670388028E-05 0.000000000000000E+00 z1= 3 -.111934342658342E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000216)=0.000000000000000E+00 (calc=0.124624319349730E+02 read=0.124624319349730E+02) Weight for this step=-.15000E+00 0.70016E+01 beta (00000217)=0.124624319349730E+02 gamma(00000217)=0.124624319349730E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 217 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000217)=0.000000000000000E+00 (calc=0.136513087510261E+02 read=0.136513087510261E+02) Weight for this step=0.17410E+00 -.60792E+01 beta (00000218)=0.136513087510261E+02 gamma(00000218)=0.136513087510261E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 218 z1= 1 -.552099851272396E-06 0.000000000000000E+00 z1= 2 0.126684375601952E-05 0.000000000000000E+00 z1= 3 0.927208759252342E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000218)=0.000000000000000E+00 (calc=0.127274228748273E+02 read=0.127274228748273E+02) Weight for this step=0.14573E+00 -.66834E+01 beta (00000219)=0.127274228748273E+02 gamma(00000219)=0.127274228748273E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 219 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000219)=0.000000000000000E+00 (calc=0.134287275413219E+02 read=0.134287275413219E+02) Weight for this step=-.17872E+00 0.61767E+01 beta (00000220)=0.134287275413219E+02 gamma(00000220)=0.134287275413219E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 220 z1= 1 0.552327883041889E-06 0.000000000000000E+00 z1= 2 -.126552096700341E-05 0.000000000000000E+00 z1= 3 -.777015787753332E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000220)=0.000000000000000E+00 (calc=0.127703454805540E+02 read=0.127703454805540E+02) Weight for this step=-.14729E+00 0.66354E+01 beta (00000221)=0.127703454805540E+02 gamma(00000221)=0.127703454805540E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 221 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000221)=0.000000000000000E+00 (calc=0.132933859257373E+02 read=0.132933859257373E+02) Weight for this step=0.17987E+00 -.61550E+01 beta (00000222)=0.132933859257373E+02 gamma(00000222)=0.132933859257373E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 222 z1= 1 -.564789806963798E-06 0.000000000000000E+00 z1= 2 0.130812859536043E-05 0.000000000000000E+00 z1= 3 0.620872185668915E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000222)=0.000000000000000E+00 (calc=0.128282704186308E+02 read=0.128282704186308E+02) Weight for this step=0.15081E+00 -.66774E+01 beta (00000223)=0.128282704186308E+02 gamma(00000223)=0.128282704186308E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 223 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000223)=0.000000000000000E+00 (calc=0.132058959439121E+02 read=0.132058959439121E+02) Weight for this step=-.17817E+00 0.60375E+01 beta (00000224)=0.132058959439121E+02 gamma(00000224)=0.132058959439121E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 224 z1= 1 0.581375468775469E-06 0.000000000000000E+00 z1= 2 -.133523817385514E-05 0.000000000000000E+00 z1= 3 -.430580993013246E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000224)=0.000000000000000E+00 (calc=0.129770362601576E+02 read=0.129770362601576E+02) Weight for this step=-.15579E+00 0.67857E+01 beta (00000225)=0.129770362601576E+02 gamma(00000225)=0.129770362601576E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 225 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000225)=0.000000000000000E+00 (calc=0.133541749785659E+02 read=0.133541749785659E+02) Weight for this step=0.17293E+00 -.58017E+01 beta (00000226)=0.133541749785659E+02 gamma(00000226)=0.133541749785659E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 226 z1= 1 -.599147315333325E-06 0.000000000000000E+00 z1= 2 0.137374016239610E-05 0.000000000000000E+00 z1= 3 0.236438321236355E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000226)=0.000000000000000E+00 (calc=0.128225244354512E+02 read=0.128225244354512E+02) Weight for this step=0.16030E+00 -.68785E+01 beta (00000227)=0.128225244354512E+02 gamma(00000227)=0.128225244354512E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 227 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000227)=0.000000000000000E+00 (calc=0.135109083731040E+02 read=0.135109083731040E+02) Weight for this step=-.17138E+00 0.56911E+01 beta (00000228)=0.135109083731040E+02 gamma(00000228)=0.135109083731040E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 228 z1= 1 0.599089202466918E-06 0.000000000000000E+00 z1= 2 -.133796892961007E-05 0.000000000000000E+00 z1= 3 -.768885985542294E-04 0.000000000000000E+00 Calculating total response charge density alpha(00000228)=0.000000000000000E+00 (calc=0.127024362018812E+02 read=0.127024362018812E+02) Weight for this step=-.16086E+00 0.68037E+01 beta (00000229)=0.127024362018812E+02 gamma(00000229)=0.127024362018812E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 229 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000229)=0.000000000000000E+00 (calc=0.134491753117693E+02 read=0.134491753117693E+02) Weight for this step=0.17346E+00 -.57027E+01 beta (00000230)=0.134491753117693E+02 gamma(00000230)=0.134491753117693E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 230 z1= 1 -.599330073211926E-06 0.000000000000000E+00 z1= 2 0.133962613777590E-05 0.000000000000000E+00 z1= 3 -.455511549428706E-04 0.000000000000000E+00 Calculating total response charge density alpha(00000230)=0.000000000000000E+00 (calc=0.129123601870796E+02 read=0.129123601870796E+02) Weight for this step=0.16079E+00 -.67035E+01 beta (00000231)=0.129123601870796E+02 gamma(00000231)=0.129123601870796E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 231 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000231)=0.000000000000000E+00 (calc=0.137268104071323E+02 read=0.137268104071323E+02) Weight for this step=-.17201E+00 0.56000E+01 beta (00000232)=0.137268104071323E+02 gamma(00000232)=0.137268104071323E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 232 z1= 1 0.598242690109420E-06 0.000000000000000E+00 z1= 2 -.130937416151179E-05 0.000000000000000E+00 z1= 3 0.113477318406291E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000232)=0.000000000000000E+00 (calc=0.127781163459516E+02 read=0.127781163459516E+02) Weight for this step=-.15986E+00 0.65728E+01 beta (00000233)=0.127781163459516E+02 gamma(00000233)=0.127781163459516E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 233 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000233)=0.000000000000000E+00 (calc=0.133503608862439E+02 read=0.133503608862439E+02) Weight for this step=0.17607E+00 -.56790E+01 beta (00000234)=0.133503608862439E+02 gamma(00000234)=0.133503608862439E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 234 z1= 1 -.616493624310314E-06 0.000000000000000E+00 z1= 2 0.132113831547364E-05 0.000000000000000E+00 z1= 3 -.180097848624033E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000234)=0.000000000000000E+00 (calc=0.125911995627005E+02 read=0.125911995627005E+02) Weight for this step=0.16207E+00 -.65695E+01 beta (00000235)=0.125911995627005E+02 gamma(00000235)=0.125911995627005E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 235 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000235)=0.000000000000000E+00 (calc=0.133931163382290E+02 read=0.133931163382290E+02) Weight for this step=-.17774E+00 0.56799E+01 beta (00000236)=0.133931163382290E+02 gamma(00000236)=0.133931163382290E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 236 z1= 1 0.618472232832455E-06 0.000000000000000E+00 z1= 2 -.127838576309688E-05 0.000000000000000E+00 z1= 3 0.213778395855775E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000236)=0.000000000000000E+00 (calc=0.128915663637625E+02 read=0.128915663637625E+02) Weight for this step=-.16148E+00 0.64538E+01 beta (00000237)=0.128915663637625E+02 gamma(00000237)=0.128915663637625E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 237 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000237)=0.000000000000000E+00 (calc=0.135197269058366E+02 read=0.135197269058366E+02) Weight for this step=0.17596E+00 -.55732E+01 beta (00000238)=0.135197269058366E+02 gamma(00000238)=0.135197269058366E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 238 z1= 1 -.624748068315693E-06 0.000000000000000E+00 z1= 2 0.127059262056405E-05 0.000000000000000E+00 z1= 3 -.247498403681875E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000238)=0.000000000000000E+00 (calc=0.127636398943868E+02 read=0.127636398943868E+02) Weight for this step=0.16291E+00 -.64237E+01 beta (00000239)=0.127636398943868E+02 gamma(00000239)=0.127636398943868E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 239 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000239)=0.000000000000000E+00 (calc=0.133597369963080E+02 read=0.133597369963080E+02) Weight for this step=-.17752E+00 0.55739E+01 beta (00000240)=0.133597369963080E+02 gamma(00000240)=0.133597369963080E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 240 z1= 1 0.638986445368819E-06 0.000000000000000E+00 z1= 2 -.126376980639234E-05 0.000000000000000E+00 z1= 3 0.255295343547981E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000240)=0.000000000000000E+00 (calc=0.127491151141515E+02 read=0.127491151141515E+02) Weight for this step=-.16475E+00 0.64102E+01 beta (00000241)=0.127491151141515E+02 gamma(00000241)=0.127491151141515E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 241 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000241)=0.000000000000000E+00 (calc=0.134028997093839E+02 read=0.134028997093839E+02) Weight for this step=0.17706E+00 -.55117E+01 beta (00000242)=0.134028997093839E+02 gamma(00000242)=0.134028997093839E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 242 z1= 1 -.643583546281867E-06 0.000000000000000E+00 z1= 2 0.125292513722879E-05 0.000000000000000E+00 z1= 3 -.217520493399131E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000242)=0.000000000000000E+00 (calc=0.128892925646346E+02 read=0.128892925646346E+02) Weight for this step=0.16578E+00 -.63667E+01 beta (00000243)=0.128892925646346E+02 gamma(00000243)=0.128892925646346E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 243 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000243)=0.000000000000000E+00 (calc=0.135139827227624E+02 read=0.135139827227624E+02) Weight for this step=-.17520E+00 0.54080E+01 beta (00000244)=0.135139827227624E+02 gamma(00000244)=0.135139827227624E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 244 z1= 1 0.646958573288976E-06 0.000000000000000E+00 z1= 2 -.123568839233590E-05 0.000000000000000E+00 z1= 3 0.176642108764853E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000244)=0.000000000000000E+00 (calc=0.125465531289791E+02 read=0.125465531289791E+02) Weight for this step=-.16700E+00 0.63343E+01 beta (00000245)=0.125465531289791E+02 gamma(00000245)=0.125465531289791E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 245 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000245)=0.000000000000000E+00 (calc=0.130511057384515E+02 read=0.130511057384515E+02) Weight for this step=0.17949E+00 -.54946E+01 beta (00000246)=0.130511057384515E+02 gamma(00000246)=0.130511057384515E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 246 z1= 1 -.669068605404794E-06 0.000000000000000E+00 z1= 2 0.124275464801675E-05 0.000000000000000E+00 z1= 3 -.686764803304700E-04 0.000000000000000E+00 Calculating total response charge density alpha(00000246)=0.000000000000000E+00 (calc=0.125672194218394E+02 read=0.125672194218394E+02) Weight for this step=0.16997E+00 -.63650E+01 beta (00000247)=0.125672194218394E+02 gamma(00000247)=0.125672194218394E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 247 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000247)=0.000000000000000E+00 (calc=0.133322000903193E+02 read=0.133322000903193E+02) Weight for this step=-.17705E+00 0.53746E+01 beta (00000248)=0.133322000903193E+02 gamma(00000248)=0.133322000903193E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 248 z1= 1 0.681577942250578E-06 0.000000000000000E+00 z1= 2 -.123381701972245E-05 0.000000000000000E+00 z1= 3 -.266689805971960E-04 0.000000000000000E+00 Calculating total response charge density alpha(00000248)=0.000000000000000E+00 (calc=0.127880968096045E+02 read=0.127880968096045E+02) Weight for this step=-.16931E+00 0.62637E+01 beta (00000249)=0.127880968096045E+02 gamma(00000249)=0.127880968096045E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 249 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000249)=0.000000000000000E+00 (calc=0.134565581046965E+02 read=0.134565581046965E+02) Weight for this step=0.17542E+00 -.52827E+01 beta (00000250)=0.134565581046965E+02 gamma(00000250)=0.134565581046965E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 250 z1= 1 -.694963790836151E-06 0.000000000000000E+00 z1= 2 0.122023517276529E-05 0.000000000000000E+00 z1= 3 0.128802028552043E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000250)=0.000000000000000E+00 (calc=0.125503690253823E+02 read=0.125503690253823E+02) Weight for this step=0.16983E+00 -.62095E+01 beta (00000251)=0.125503690253823E+02 gamma(00000251)=0.125503690253823E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 251 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000251)=0.000000000000000E+00 (calc=0.132840585916851E+02 read=0.132840585916851E+02) Weight for this step=-.17874E+00 0.53402E+01 beta (00000252)=0.132840585916851E+02 gamma(00000252)=0.132840585916851E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 252 z1= 1 0.714218952106303E-06 0.000000000000000E+00 z1= 2 -.121037865157372E-05 0.000000000000000E+00 z1= 3 -.179274714231667E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000252)=0.000000000000000E+00 (calc=0.129336467496663E+02 read=0.129336467496663E+02) Weight for this step=-.16966E+00 0.61297E+01 beta (00000253)=0.129336467496663E+02 gamma(00000253)=0.129336467496663E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 253 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000253)=0.000000000000000E+00 (calc=0.135149193239822E+02 read=0.135149193239822E+02) Weight for this step=0.17452E+00 -.51747E+01 beta (00000254)=0.135149193239822E+02 gamma(00000254)=0.135149193239822E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 254 z1= 1 -.735231184990719E-06 0.000000000000000E+00 z1= 2 0.120195177215625E-05 0.000000000000000E+00 z1= 3 0.150988149145704E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000254)=0.000000000000000E+00 (calc=0.128019352131742E+02 read=0.128019352131742E+02) Weight for this step=0.17119E+00 -.61167E+01 beta (00000255)=0.128019352131742E+02 gamma(00000255)=0.128019352131742E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 255 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000255)=0.000000000000000E+00 (calc=0.136716720200583E+02 read=0.136716720200583E+02) Weight for this step=-.17501E+00 0.51501E+01 beta (00000256)=0.136716720200583E+02 gamma(00000256)=0.136716720200583E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 256 z1= 1 0.740090766522712E-06 0.000000000000000E+00 z1= 2 -.118564917640329E-05 0.000000000000000E+00 z1= 3 -.137059842599200E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000256)=0.000000000000000E+00 (calc=0.128300169711027E+02 read=0.128300169711027E+02) Weight for this step=-.16906E+00 0.59741E+01 beta (00000257)=0.128300169711027E+02 gamma(00000257)=0.128300169711027E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 257 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000257)=0.000000000000000E+00 (calc=0.134221764225424E+02 read=0.134221764225424E+02) Weight for this step=0.17740E+00 -.51832E+01 beta (00000258)=0.134221764225424E+02 gamma(00000258)=0.134221764225424E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 258 z1= 1 -.763114090801022E-06 0.000000000000000E+00 z1= 2 0.117708801347519E-05 0.000000000000000E+00 z1= 3 0.138314965273885E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000258)=0.000000000000000E+00 (calc=0.130324414893717E+02 read=0.130324414893717E+02) Weight for this step=0.17064E+00 -.59633E+01 beta (00000259)=0.130324414893717E+02 gamma(00000259)=0.130324414893717E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 259 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000259)=0.000000000000000E+00 (calc=0.135340611114582E+02 read=0.135340611114582E+02) Weight for this step=-.17367E+00 0.50387E+01 beta (00000260)=0.135340611114582E+02 gamma(00000260)=0.135340611114582E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 260 z1= 1 0.786494248650323E-06 0.000000000000000E+00 z1= 2 -.117528697542450E-05 0.000000000000000E+00 z1= 3 -.928929111123130E-04 0.000000000000000E+00 Calculating total response charge density alpha(00000260)=0.000000000000000E+00 (calc=0.127717003129934E+02 read=0.127717003129934E+02) Weight for this step=-.17309E+00 0.59860E+01 beta (00000261)=0.127717003129934E+02 gamma(00000261)=0.127717003129934E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 261 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000261)=0.000000000000000E+00 (calc=0.133221254906216E+02 read=0.133221254906216E+02) Weight for this step=0.17470E+00 -.50327E+01 beta (00000262)=0.133221254906216E+02 gamma(00000262)=0.133221254906216E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 262 z1= 1 -.808548144851811E-06 0.000000000000000E+00 z1= 2 0.114094107089748E-05 0.000000000000000E+00 z1= 3 0.479945003352845E-04 0.000000000000000E+00 Calculating total response charge density alpha(00000262)=0.000000000000000E+00 (calc=0.126369348152825E+02 read=0.126369348152825E+02) Weight for this step=0.17490E+00 -.59860E+01 beta (00000263)=0.126369348152825E+02 gamma(00000263)=0.126369348152825E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 263 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000263)=0.000000000000000E+00 (calc=0.132587151044912E+02 read=0.132587151044912E+02) Weight for this step=-.17464E+00 0.49955E+01 beta (00000264)=0.132587151044912E+02 gamma(00000264)=0.132587151044912E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 264 z1= 1 0.832728670075025E-06 0.000000000000000E+00 z1= 2 -.111459423533350E-05 0.000000000000000E+00 z1= 3 -.468145628130731E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000264)=0.000000000000000E+00 (calc=0.127327481978581E+02 read=0.127327481978581E+02) Weight for this step=-.17569E+00 0.59519E+01 beta (00000265)=0.127327481978581E+02 gamma(00000265)=0.127327481978581E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 265 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000265)=0.000000000000000E+00 (calc=0.134480083555586E+02 read=0.134480083555586E+02) Weight for this step=0.17235E+00 -.48958E+01 beta (00000266)=0.134480083555586E+02 gamma(00000266)=0.134480083555586E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 266 z1= 1 -.847673392096276E-06 0.000000000000000E+00 z1= 2 0.107591641115178E-05 0.000000000000000E+00 z1= 3 0.661403806914446E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000266)=0.000000000000000E+00 (calc=0.127991069567262E+02 read=0.127991069567262E+02) Weight for this step=0.17510E+00 -.58736E+01 beta (00000267)=0.127991069567262E+02 gamma(00000267)=0.127991069567262E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 267 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000267)=0.000000000000000E+00 (calc=0.133509648125398E+02 read=0.133509648125398E+02) Weight for this step=-.17167E+00 0.48437E+01 beta (00000268)=0.133509648125398E+02 gamma(00000268)=0.133509648125398E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 268 z1= 1 0.861293865518214E-06 0.000000000000000E+00 z1= 2 -.105054333559413E-05 0.000000000000000E+00 z1= 3 -.568672725593123E-04 0.000000000000000E+00 Calculating total response charge density alpha(00000268)=0.000000000000000E+00 (calc=0.126159938733929E+02 read=0.126159938733929E+02) Weight for this step=-.17665E+00 0.58683E+01 beta (00000269)=0.126159938733929E+02 gamma(00000269)=0.126159938733929E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 269 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000269)=0.000000000000000E+00 (calc=0.135207238563646E+02 read=0.135207238563646E+02) Weight for this step=0.17205E+00 -.48214E+01 beta (00000270)=0.135207238563646E+02 gamma(00000270)=0.135207238563646E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 270 z1= 1 -.850933597511657E-06 0.000000000000000E+00 z1= 2 0.978869600185619E-06 0.000000000000000E+00 z1= 3 0.127265639789825E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000270)=0.000000000000000E+00 (calc=0.130324123235257E+02 read=0.130324123235257E+02) Weight for this step=0.17351E+00 -.57090E+01 beta (00000271)=0.130324123235257E+02 gamma(00000271)=0.130324123235257E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 271 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000271)=0.000000000000000E+00 (calc=0.132956027752198E+02 read=0.132956027752198E+02) Weight for this step=-.16934E+00 0.47153E+01 beta (00000272)=0.132956027752198E+02 gamma(00000272)=0.132956027752198E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 272 z1= 1 0.886784847518239E-06 0.000000000000000E+00 z1= 2 -.965208470624567E-06 0.000000000000000E+00 z1= 3 -.191859941941791E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000272)=0.000000000000000E+00 (calc=0.127269484826188E+02 read=0.127269484826188E+02) Weight for this step=-.17877E+00 0.58282E+01 beta (00000273)=0.127269484826188E+02 gamma(00000273)=0.127269484826188E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 273 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000273)=0.000000000000000E+00 (calc=0.134985180404545E+02 read=0.134985180404545E+02) Weight for this step=0.16725E+00 -.46262E+01 beta (00000274)=0.134985180404545E+02 gamma(00000274)=0.134985180404545E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 274 z1= 1 -.880262715664414E-06 0.000000000000000E+00 z1= 2 0.892739654720614E-06 0.000000000000000E+00 z1= 3 0.170461107319943E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000274)=0.000000000000000E+00 (calc=0.128622180561738E+02 read=0.128622180561738E+02) Weight for this step=0.17700E+00 -.57194E+01 beta (00000275)=0.128622180561738E+02 gamma(00000275)=0.128622180561738E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 275 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000275)=0.000000000000000E+00 (calc=0.137440373074687E+02 read=0.137440373074687E+02) Weight for this step=-.16607E+00 0.45640E+01 beta (00000276)=0.137440373074687E+02 gamma(00000276)=0.137440373074687E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 276 z1= 1 0.873160536215536E-06 0.000000000000000E+00 z1= 2 -.823044611975845E-06 0.000000000000000E+00 z1= 3 -.142874387783048E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000276)=0.000000000000000E+00 (calc=0.127464619913646E+02 read=0.127464619913646E+02) Weight for this step=-.17389E+00 0.55698E+01 beta (00000277)=0.127464619913646E+02 gamma(00000277)=0.127464619913646E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 277 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000277)=0.000000000000000E+00 (calc=0.131863522853378E+02 read=0.131863522853378E+02) Weight for this step=0.16970E+00 -.46352E+01 beta (00000278)=0.131863522853378E+02 gamma(00000278)=0.131863522853378E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 278 z1= 1 -.901672133882172E-06 0.000000000000000E+00 z1= 2 0.771039879108909E-06 0.000000000000000E+00 z1= 3 0.109693624388935E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000278)=0.000000000000000E+00 (calc=0.125348482581493E+02 read=0.125348482581493E+02) Weight for this step=0.17686E+00 -.56140E+01 beta (00000279)=0.125348482581493E+02 gamma(00000279)=0.125348482581493E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 279 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000279)=0.000000000000000E+00 (calc=0.133613074100773E+02 read=0.133613074100773E+02) Weight for this step=-.16884E+00 0.45829E+01 beta (00000280)=0.133613074100773E+02 gamma(00000280)=0.133613074100773E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 280 z1= 1 0.896016078226003E-06 0.000000000000000E+00 z1= 2 -.703776936694244E-06 0.000000000000000E+00 z1= 3 -.761180235772669E-04 0.000000000000000E+00 Calculating total response charge density alpha(00000280)=0.000000000000000E+00 (calc=0.128734583968289E+02 read=0.128734583968289E+02) Weight for this step=-.17454E+00 0.54913E+01 beta (00000281)=0.128734583968289E+02 gamma(00000281)=0.128734583968289E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 281 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000281)=0.000000000000000E+00 (calc=0.132961392437314E+02 read=0.132961392437314E+02) Weight for this step=0.16594E+00 -.44774E+01 beta (00000282)=0.132961392437314E+02 gamma(00000282)=0.132961392437314E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 282 z1= 1 -.912535820926739E-06 0.000000000000000E+00 z1= 2 0.647095085784782E-06 0.000000000000000E+00 z1= 3 0.277690949047182E-04 0.000000000000000E+00 Calculating total response charge density alpha(00000282)=0.000000000000000E+00 (calc=0.125942948075747E+02 read=0.125942948075747E+02) Weight for this step=0.17750E+00 -.55372E+01 beta (00000283)=0.125942948075747E+02 gamma(00000283)=0.125942948075747E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 283 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000283)=0.000000000000000E+00 (calc=0.132143367708970E+02 read=0.132143367708970E+02) Weight for this step=-.16552E+00 0.44391E+01 beta (00000284)=0.132143367708970E+02 gamma(00000284)=0.132143367708970E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 284 z1= 1 0.909746900843041E-06 0.000000000000000E+00 z1= 2 -.573979622587228E-06 0.000000000000000E+00 z1= 3 0.582131013957144E-04 0.000000000000000E+00 Calculating total response charge density alpha(00000284)=0.000000000000000E+00 (calc=0.126628114296173E+02 read=0.126628114296173E+02) Weight for this step=-.17770E+00 0.54972E+01 beta (00000285)=0.126628114296173E+02 gamma(00000285)=0.126628114296173E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 285 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000285)=0.000000000000000E+00 (calc=0.134122097358556E+02 read=0.134122097358556E+02) Weight for this step=0.16311E+00 -.43483E+01 beta (00000286)=0.134122097358556E+02 gamma(00000286)=0.134122097358556E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 286 z1= 1 -.905927851428874E-06 0.000000000000000E+00 z1= 2 0.504138144356544E-06 0.000000000000000E+00 z1= 3 -.190832693180655E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000286)=0.000000000000000E+00 (calc=0.126240012323494E+02 read=0.126240012323494E+02) Weight for this step=0.17606E+00 -.54023E+01 beta (00000287)=0.126240012323494E+02 gamma(00000287)=0.126240012323494E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 287 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000287)=0.000000000000000E+00 (calc=0.130876656465496E+02 read=0.130876656465496E+02) Weight for this step=-.16373E+00 0.43397E+01 beta (00000288)=0.130876656465496E+02 gamma(00000288)=0.130876656465496E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 288 z1= 1 0.920525971781548E-06 0.000000000000000E+00 z1= 2 -.414213907049368E-06 0.000000000000000E+00 z1= 3 0.349602154668134E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000288)=0.000000000000000E+00 (calc=0.127646911930806E+02 read=0.127646911930806E+02) Weight for this step=-.17834E+00 0.54279E+01 beta (00000289)=0.127646911930806E+02 gamma(00000289)=0.127646911930806E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 289 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000289)=0.000000000000000E+00 (calc=0.134266767108745E+02 read=0.134266767108745E+02) Weight for this step=0.15831E+00 -.41712E+01 beta (00000290)=0.134266767108745E+02 gamma(00000290)=0.134266767108745E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 290 z1= 1 -.927088723384718E-06 0.000000000000000E+00 z1= 2 0.344783483439634E-06 0.000000000000000E+00 z1= 3 -.501146048350665E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000290)=0.000000000000000E+00 (calc=0.127607112298001E+02 read=0.127607112298001E+02) Weight for this step=0.17758E+00 -.53637E+01 beta (00000291)=0.127607112298001E+02 gamma(00000291)=0.127607112298001E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 291 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000291)=0.000000000000000E+00 (calc=0.131977198915219E+02 read=0.131977198915219E+02) Weight for this step=-.15704E+00 0.41137E+01 beta (00000292)=0.131977198915219E+02 gamma(00000292)=0.131977198915219E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 292 z1= 1 0.944096389550540E-06 0.000000000000000E+00 z1= 2 -.251664361859358E-06 0.000000000000000E+00 z1= 3 0.625281949561881E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000292)=0.000000000000000E+00 (calc=0.126412176915661E+02 read=0.126412176915661E+02) Weight for this step=-.17980E+00 0.53901E+01 beta (00000293)=0.126412176915661E+02 gamma(00000293)=0.126412176915661E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 293 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000293)=0.000000000000000E+00 (calc=0.135269362636948E+02 read=0.135269362636948E+02) Weight for this step=0.15421E+00 -.40157E+01 beta (00000294)=0.135269362636948E+02 gamma(00000294)=0.135269362636948E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 294 z1= 1 -.913285294410772E-06 0.000000000000000E+00 z1= 2 0.198728392220915E-06 0.000000000000000E+00 z1= 3 -.725818894986055E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000294)=0.000000000000000E+00 (calc=0.129785103637072E+02 read=0.129785103637072E+02) Weight for this step=0.17579E+00 -.52315E+01 beta (00000295)=0.129785103637072E+02 gamma(00000295)=0.129785103637072E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 295 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000295)=0.000000000000000E+00 (calc=0.135622799739159E+02 read=0.135622799739159E+02) Weight for this step=-.15146E+00 0.39215E+01 beta (00000296)=0.135622799739159E+02 gamma(00000296)=0.135622799739159E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 296 z1= 1 0.904610691123515E-06 0.000000000000000E+00 z1= 2 -.129533907027691E-06 0.000000000000000E+00 z1= 3 0.768601384177944E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000296)=0.000000000000000E+00 (calc=0.127907385325438E+02 read=0.127907385325438E+02) Weight for this step=-.17582E+00 0.51956E+01 beta (00000297)=0.127907385325438E+02 gamma(00000297)=0.127907385325438E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 297 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000297)=0.000000000000000E+00 (calc=0.133436961898626E+02 read=0.133436961898626E+02) Weight for this step=0.15119E+00 -.38922E+01 beta (00000298)=0.133436961898626E+02 gamma(00000298)=0.133436961898626E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 298 z1= 1 -.902351524952158E-06 0.000000000000000E+00 z1= 2 0.910101934221253E-07 0.000000000000000E+00 z1= 3 -.707462199360926E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000298)=0.000000000000000E+00 (calc=0.130107129245938E+02 read=0.130107129245938E+02) Weight for this step=0.17624E+00 -.51712E+01 beta (00000299)=0.130107129245938E+02 gamma(00000299)=0.130107129245938E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 299 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000299)=0.000000000000000E+00 (calc=0.136889177698054E+02 read=0.136889177698054E+02) Weight for this step=-.14580E+00 0.37317E+01 beta (00000300)=0.136889177698054E+02 gamma(00000300)=0.136889177698054E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 300 z1= 1 0.890870992606950E-06 0.000000000000000E+00 z1= 2 -.324937566420034E-07 0.000000000000000E+00 z1= 3 0.684585814798610E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000300)=0.000000000000000E+00 (calc=0.127325779102483E+02 read=0.127325779102483E+02) Weight for this step=-.17475E+00 0.50934E+01 beta (00000301)=0.127325779102483E+02 gamma(00000301)=0.127325779102483E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 301 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000301)=0.000000000000000E+00 (calc=0.132014512645709E+02 read=0.132014512645709E+02) Weight for this step=0.14736E+00 -.37501E+01 beta (00000302)=0.132014512645709E+02 gamma(00000302)=0.132014512645709E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 302 z1= 1 -.907215534756245E-06 0.000000000000000E+00 z1= 2 0.749085360391257E-08 0.000000000000000E+00 z1= 3 -.647234596798748E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000302)=0.000000000000000E+00 (calc=0.127870291940223E+02 read=0.127870291940223E+02) Weight for this step=0.17614E+00 -.50985E+01 beta (00000303)=0.127870291940223E+02 gamma(00000303)=0.127870291940223E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 303 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000303)=0.000000000000000E+00 (calc=0.135647528982383E+02 read=0.135647528982383E+02) Weight for this step=-.14272E+00 0.36106E+01 beta (00000304)=0.135647528982383E+02 gamma(00000304)=0.135647528982383E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 304 z1= 1 0.898162290781878E-06 0.000000000000000E+00 z1= 2 0.177070342863121E-07 0.000000000000000E+00 z1= 3 0.551157711890096E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000304)=0.000000000000000E+00 (calc=0.128308746770530E+02 read=0.128308746770530E+02) Weight for this step=-.17319E+00 0.49804E+01 beta (00000305)=0.128308746770530E+02 gamma(00000305)=0.128308746770530E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 305 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000305)=0.000000000000000E+00 (calc=0.134495333915455E+02 read=0.134495333915455E+02) Weight for this step=0.14166E+00 -.35631E+01 beta (00000306)=0.134495333915455E+02 gamma(00000306)=0.134495333915455E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 306 z1= 1 -.898325725562127E-06 0.000000000000000E+00 z1= 2 -.394639419778976E-07 0.000000000000000E+00 z1= 3 -.426466961671488E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000306)=0.000000000000000E+00 (calc=0.127987548196408E+02 read=0.127987548196408E+02) Weight for this step=0.17239E+00 -.49247E+01 beta (00000307)=0.127987548196408E+02 gamma(00000307)=0.127987548196408E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 307 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000307)=0.000000000000000E+00 (calc=0.135696286728768E+02 read=0.135696286728768E+02) Weight for this step=-.13967E+00 0.34924E+01 beta (00000308)=0.135696286728768E+02 gamma(00000308)=0.135696286728768E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 308 z1= 1 0.883900267442434E-06 0.000000000000000E+00 z1= 2 0.676048127881473E-07 0.000000000000000E+00 z1= 3 0.239683958884571E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000308)=0.000000000000000E+00 (calc=0.127885424282874E+02 read=0.127885424282874E+02) Weight for this step=-.16959E+00 0.48134E+01 beta (00000309)=0.127885424282874E+02 gamma(00000309)=0.127885424282874E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 309 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000309)=0.000000000000000E+00 (calc=0.133077706194535E+02 read=0.133077706194535E+02) Weight for this step=0.13914E+00 -.34593E+01 beta (00000310)=0.133077706194535E+02 gamma(00000310)=0.133077706194535E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 310 z1= 1 -.877730504446889E-06 0.000000000000000E+00 z1= 2 -.111977246935947E-06 0.000000000000000E+00 z1= 3 -.705534329373504E-04 0.000000000000000E+00 Calculating total response charge density alpha(00000310)=0.000000000000000E+00 (calc=0.127286652128317E+02 read=0.127286652128317E+02) Weight for this step=0.17008E+00 -.47957E+01 beta (00000311)=0.127286652128317E+02 gamma(00000311)=0.127286652128317E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 311 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000311)=0.000000000000000E+00 (calc=0.134430723654603E+02 read=0.134430723654603E+02) Weight for this step=-.13635E+00 0.33701E+01 beta (00000312)=0.134430723654603E+02 gamma(00000312)=0.134430723654603E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 312 z1= 1 0.863238084699953E-06 0.000000000000000E+00 z1= 2 0.136260184745466E-06 0.000000000000000E+00 z1= 3 -.739101787417412E-04 0.000000000000000E+00 Calculating total response charge density alpha(00000312)=0.000000000000000E+00 (calc=0.128578417714761E+02 read=0.128578417714761E+02) Weight for this step=-.16793E+00 0.47050E+01 beta (00000313)=0.128578417714761E+02 gamma(00000313)=0.128578417714761E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 313 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000313)=0.000000000000000E+00 (calc=0.132261668904193E+02 read=0.132261668904193E+02) Weight for this step=0.13364E+00 -.32840E+01 beta (00000314)=0.132261668904193E+02 gamma(00000314)=0.132261668904193E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 314 z1= 1 -.880491916493032E-06 0.000000000000000E+00 z1= 2 -.152204755812357E-06 0.000000000000000E+00 z1= 3 0.259051417070941E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000314)=0.000000000000000E+00 (calc=0.124474653558697E+02 read=0.124474653558697E+02) Weight for this step=0.17011E+00 -.47365E+01 beta (00000315)=0.124474653558697E+02 gamma(00000315)=0.124474653558697E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 315 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000315)=0.000000000000000E+00 (calc=0.134572295461685E+02 read=0.134572295461685E+02) Weight for this step=-.13267E+00 0.32403E+01 beta (00000316)=0.134572295461685E+02 gamma(00000316)=0.134572295461685E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 316 z1= 1 0.855648727509880E-06 0.000000000000000E+00 z1= 2 0.114089638967967E-06 0.000000000000000E+00 z1= 3 -.403939736499230E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000316)=0.000000000000000E+00 (calc=0.125627955037059E+02 read=0.125627955037059E+02) Weight for this step=-.16404E+00 0.45387E+01 beta (00000317)=0.125627955037059E+02 gamma(00000317)=0.125627955037059E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 317 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000317)=0.000000000000000E+00 (calc=0.134454928742506E+02 read=0.134454928742506E+02) Weight for this step=0.13321E+00 -.32346E+01 beta (00000318)=0.134454928742506E+02 gamma(00000318)=0.134454928742506E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 318 z1= 1 -.844807595412373E-06 0.000000000000000E+00 z1= 2 -.121145142256023E-06 0.000000000000000E+00 z1= 3 0.507365695535941E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000318)=0.000000000000000E+00 (calc=0.125691302141704E+02 read=0.125691302141704E+02) Weight for this step=0.16000E+00 -.43982E+01 beta (00000319)=0.125691302141704E+02 gamma(00000319)=0.125691302141704E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 319 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000319)=0.000000000000000E+00 (calc=0.132683663925298E+02 read=0.132683663925298E+02) Weight for this step=-.13381E+00 0.32311E+01 beta (00000320)=0.132683663925298E+02 gamma(00000320)=0.132683663925298E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 320 z1= 1 0.850280824967115E-06 0.000000000000000E+00 z1= 2 0.824821224012368E-07 0.000000000000000E+00 z1= 3 -.613601695922263E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000320)=0.000000000000000E+00 (calc=0.128768110279527E+02 read=0.128768110279527E+02) Weight for this step=-.15841E+00 0.43258E+01 beta (00000321)=0.128768110279527E+02 gamma(00000321)=0.128768110279527E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 321 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000321)=0.000000000000000E+00 (calc=0.135396497745297E+02 read=0.135396497745297E+02) Weight for this step=0.12949E+00 -.31094E+01 beta (00000322)=0.135396497745297E+02 gamma(00000322)=0.135396497745297E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 322 z1= 1 -.859388994718354E-06 0.000000000000000E+00 z1= 2 -.682788659457298E-07 0.000000000000000E+00 z1= 3 0.611415171835786E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000322)=0.000000000000000E+00 (calc=0.127480230295985E+02 read=0.127480230295985E+02) Weight for this step=0.15715E+00 -.42643E+01 beta (00000323)=0.127480230295985E+02 gamma(00000323)=0.127480230295985E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 323 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000323)=0.000000000000000E+00 (calc=0.132686535438582E+02 read=0.132686535438582E+02) Weight for this step=-.12913E+00 0.30835E+01 beta (00000324)=0.132686535438582E+02 gamma(00000324)=0.132686535438582E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 324 z1= 1 0.867822754048854E-06 0.000000000000000E+00 z1= 2 0.230282640349211E-07 0.000000000000000E+00 z1= 3 -.593169576848551E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000324)=0.000000000000000E+00 (calc=0.127942782488542E+02 read=0.127942782488542E+02) Weight for this step=-.15758E+00 0.42491E+01 beta (00000325)=0.127942782488542E+02 gamma(00000325)=0.127942782488542E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 325 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000325)=0.000000000000000E+00 (calc=0.137026903697314E+02 read=0.137026903697314E+02) Weight for this step=0.12552E+00 -.29805E+01 beta (00000326)=0.137026903697314E+02 gamma(00000326)=0.137026903697314E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 326 z1= 1 -.846318298243758E-06 0.000000000000000E+00 z1= 2 -.422199867368997E-07 0.000000000000000E+00 z1= 3 0.515054913427835E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000326)=0.000000000000000E+00 (calc=0.126562903837119E+02 read=0.126562903837119E+02) Weight for this step=0.15335E+00 -.41098E+01 beta (00000327)=0.126562903837119E+02 gamma(00000327)=0.126562903837119E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 327 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000327)=0.000000000000000E+00 (calc=0.132710876207405E+02 read=0.132710876207405E+02) Weight for this step=-.12764E+00 0.30143E+01 beta (00000328)=0.132710876207405E+02 gamma(00000328)=0.132710876207405E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 328 z1= 1 0.850153775519222E-06 0.000000000000000E+00 z1= 2 0.840304238409854E-09 0.000000000000000E+00 z1= 3 -.372100983301336E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000328)=0.000000000000000E+00 (calc=0.128093879753903E+02 read=0.128093879753903E+02) Weight for this step=-.15277E+00 0.40681E+01 beta (00000329)=0.128093879753903E+02 gamma(00000329)=0.128093879753903E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 329 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000329)=0.000000000000000E+00 (calc=0.136222136818207E+02 read=0.136222136818207E+02) Weight for this step=0.12412E+00 -.29151E+01 beta (00000330)=0.136222136818207E+02 gamma(00000330)=0.136222136818207E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 330 z1= 1 -.844103226407789E-06 0.000000000000000E+00 z1= 2 -.621522715932299E-08 0.000000000000000E+00 z1= 3 0.204082680014494E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000330)=0.000000000000000E+00 (calc=0.126670155461000E+02 read=0.126670155461000E+02) Weight for this step=0.14983E+00 -.39654E+01 beta (00000331)=0.126670155461000E+02 gamma(00000331)=0.126670155461000E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 331 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000331)=0.000000000000000E+00 (calc=0.133665195552515E+02 read=0.133665195552515E+02) Weight for this step=-.12542E+00 0.29300E+01 beta (00000332)=0.133665195552515E+02 gamma(00000332)=0.133665195552515E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 332 z1= 1 0.845856735538710E-06 0.000000000000000E+00 z1= 2 -.369065611687967E-07 0.000000000000000E+00 z1= 3 0.539121473667678E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000332)=0.000000000000000E+00 (calc=0.128362148765585E+02 read=0.128362148765585E+02) Weight for this step=-.14835E+00 0.39014E+01 beta (00000333)=0.128362148765585E+02 gamma(00000333)=0.128362148765585E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 333 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000333)=0.000000000000000E+00 (calc=0.134610356272610E+02 read=0.134610356272610E+02) Weight for this step=0.12273E+00 -.28521E+01 beta (00000334)=0.134610356272610E+02 gamma(00000334)=0.134610356272610E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 334 z1= 1 -.858421598338229E-06 0.000000000000000E+00 z1= 2 0.389724881014560E-07 0.000000000000000E+00 z1= 3 -.149842481847965E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000334)=0.000000000000000E+00 (calc=0.124678085059625E+02 read=0.124678085059625E+02) Weight for this step=0.14765E+00 -.38590E+01 beta (00000335)=0.124678085059625E+02 gamma(00000335)=0.124678085059625E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 335 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000335)=0.000000000000000E+00 (calc=0.130935794311875E+02 read=0.130935794311875E+02) Weight for this step=-.12445E+00 0.28767E+01 beta (00000336)=0.130935794311875E+02 gamma(00000336)=0.130935794311875E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 336 z1= 1 0.877570924426806E-06 0.000000000000000E+00 z1= 2 -.107652106678176E-06 0.000000000000000E+00 z1= 3 0.268413491873591E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000336)=0.000000000000000E+00 (calc=0.129076557638503E+02 read=0.129076557638503E+02) Weight for this step=-.14703E+00 0.38184E+01 beta (00000337)=0.129076557638503E+02 gamma(00000337)=0.129076557638503E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 337 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000337)=0.000000000000000E+00 (calc=0.135012750844191E+02 read=0.135012750844191E+02) Weight for this step=0.11849E+00 -.27245E+01 beta (00000338)=0.135012750844191E+02 gamma(00000338)=0.135012750844191E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 338 z1= 1 -.895659383552097E-06 0.000000000000000E+00 z1= 2 0.125122275080865E-06 0.000000000000000E+00 z1= 3 -.430408545219299E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000338)=0.000000000000000E+00 (calc=0.126384417861600E+02 read=0.126384417861600E+02) Weight for this step=0.14651E+00 -.37826E+01 beta (00000339)=0.126384417861600E+02 gamma(00000339)=0.126384417861600E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 339 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000339)=0.000000000000000E+00 (calc=0.132421932688249E+02 read=0.132421932688249E+02) Weight for this step=-.11869E+00 0.27146E+01 beta (00000340)=0.132421932688249E+02 gamma(00000340)=0.132421932688249E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 340 z1= 1 0.918066488875312E-06 0.000000000000000E+00 z1= 2 -.184947598884583E-06 0.000000000000000E+00 z1= 3 0.595932060826173E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000340)=0.000000000000000E+00 (calc=0.126706887890930E+02 read=0.126706887890930E+02) Weight for this step=-.14591E+00 0.37443E+01 beta (00000341)=0.126706887890930E+02 gamma(00000341)=0.126706887890930E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 341 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000341)=0.000000000000000E+00 (calc=0.136753373053318E+02 read=0.136753373053318E+02) Weight for this step=0.11621E+00 -.26437E+01 beta (00000342)=0.136753373053318E+02 gamma(00000342)=0.136753373053318E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 342 z1= 1 -.913329590250772E-06 0.000000000000000E+00 z1= 2 0.178172007115241E-06 0.000000000000000E+00 z1= 3 -.712408318393627E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000342)=0.000000000000000E+00 (calc=0.127943450206585E+02 read=0.127943450206585E+02) Weight for this step=0.14094E+00 -.35958E+01 beta (00000343)=0.127943450206585E+02 gamma(00000343)=0.127943450206585E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 343 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000343)=0.000000000000000E+00 (calc=0.135431202081270E+02 read=0.135431202081270E+02) Weight for this step=-.11672E+00 0.26417E+01 beta (00000344)=0.135431202081270E+02 gamma(00000344)=0.135431202081270E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 344 z1= 1 0.934064281816918E-06 0.000000000000000E+00 z1= 2 -.216101643131235E-06 0.000000000000000E+00 z1= 3 0.858067265076525E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000344)=0.000000000000000E+00 (calc=0.129528039587151E+02 read=0.129528039587151E+02) Weight for this step=-.13899E+00 0.35246E+01 beta (00000345)=0.129528039587151E+02 gamma(00000345)=0.129528039587151E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 345 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000345)=0.000000000000000E+00 (calc=0.134551379514854E+02 read=0.134551379514854E+02) Weight for this step=0.11475E+00 -.25840E+01 beta (00000346)=0.134551379514854E+02 gamma(00000346)=0.134551379514854E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 346 z1= 1 -.961737927528903E-06 0.000000000000000E+00 z1= 2 0.223189404202867E-06 0.000000000000000E+00 z1= 3 -.104525541344297E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000346)=0.000000000000000E+00 (calc=0.125652063363612E+02 read=0.125652063363612E+02) Weight for this step=0.13957E+00 -.35188E+01 beta (00000347)=0.125652063363612E+02 gamma(00000347)=0.125652063363612E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 347 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000347)=0.000000000000000E+00 (calc=0.134783936134887E+02 read=0.134783936134887E+02) Weight for this step=-.11532E+00 0.25837E+01 beta (00000348)=0.134783936134887E+02 gamma(00000348)=0.134783936134887E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 348 z1= 1 0.964491614513529E-06 0.000000000000000E+00 z1= 2 -.258539222059307E-06 0.000000000000000E+00 z1= 3 0.116958099299417E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000348)=0.000000000000000E+00 (calc=0.129740072766135E+02 read=0.129740072766135E+02) Weight for this step=-.13591E+00 0.34058E+01 beta (00000349)=0.129740072766135E+02 gamma(00000349)=0.129740072766135E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 349 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000349)=0.000000000000000E+00 (calc=0.134297951183631E+02 read=0.134297951183631E+02) Weight for this step=0.11269E+00 -.25123E+01 beta (00000350)=0.134297951183631E+02 gamma(00000350)=0.134297951183631E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 350 z1= 1 -.993142600357543E-06 0.000000000000000E+00 z1= 2 0.256627711565580E-06 0.000000000000000E+00 z1= 3 -.135361945559912E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000350)=0.000000000000000E+00 (calc=0.125508481507069E+02 read=0.125508481507069E+02) Weight for this step=0.13698E+00 -.34127E+01 beta (00000351)=0.125508481507069E+02 gamma(00000351)=0.125508481507069E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 351 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000351)=0.000000000000000E+00 (calc=0.134338592024886E+02 read=0.134338592024886E+02) Weight for this step=-.11316E+00 0.25103E+01 beta (00000352)=0.134338592024886E+02 gamma(00000352)=0.134338592024886E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 352 z1= 1 0.100484423383503E-05 0.000000000000000E+00 z1= 2 -.266206141483942E-06 0.000000000000000E+00 z1= 3 0.143566911387661E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000352)=0.000000000000000E+00 (calc=0.129531025588947E+02 read=0.129531025588947E+02) Weight for this step=-.13367E+00 0.33107E+01 beta (00000353)=0.129531025588947E+02 gamma(00000353)=0.129531025588947E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 353 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000353)=0.000000000000000E+00 (calc=0.132873851586602E+02 read=0.132873851586602E+02) Weight for this step=0.11035E+00 -.24362E+01 beta (00000354)=0.132873851586602E+02 gamma(00000354)=0.132873851586602E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 354 z1= 1 -.105127080067256E-05 0.000000000000000E+00 z1= 2 0.265805606574775E-06 0.000000000000000E+00 z1= 3 -.157576645599267E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000354)=0.000000000000000E+00 (calc=0.124749211916428E+02 read=0.124749211916428E+02) Weight for this step=0.13593E+00 -.33474E+01 beta (00000355)=0.124749211916428E+02 gamma(00000355)=0.124749211916428E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 355 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000355)=0.000000000000000E+00 (calc=0.136130035589521E+02 read=0.136130035589521E+02) Weight for this step=-.11014E+00 0.24192E+01 beta (00000356)=0.136130035589521E+02 gamma(00000356)=0.136130035589521E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 356 z1= 1 0.102588664688548E-05 0.000000000000000E+00 z1= 2 -.263165290542776E-06 0.000000000000000E+00 z1= 3 0.166805291112152E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000356)=0.000000000000000E+00 (calc=0.128740605637155E+02 read=0.128740605637155E+02) Weight for this step=-.13004E+00 0.31839E+01 beta (00000357)=0.128740605637155E+02 gamma(00000357)=0.128740605637155E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 357 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000357)=0.000000000000000E+00 (calc=0.136854335673632E+02 read=0.136854335673632E+02) Weight for this step=0.10960E+00 -.23962E+01 beta (00000358)=0.136854335673632E+02 gamma(00000358)=0.136854335673632E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 358 z1= 1 -.104557596819016E-05 0.000000000000000E+00 z1= 2 0.261827523835036E-06 0.000000000000000E+00 z1= 3 -.178727968344997E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000358)=0.000000000000000E+00 (calc=0.126594349078977E+02 read=0.126594349078977E+02) Weight for this step=0.12775E+00 -.31097E+01 beta (00000359)=0.126594349078977E+02 gamma(00000359)=0.126594349078977E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 359 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000359)=0.000000000000000E+00 (calc=0.138515883939966E+02 read=0.138515883939966E+02) Weight for this step=-.11163E+00 0.24296E+01 beta (00000360)=0.138515883939966E+02 gamma(00000360)=0.138515883939966E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 360 z1= 1 0.103529983025205E-05 0.000000000000000E+00 z1= 2 -.247960698768679E-06 0.000000000000000E+00 z1= 3 0.183613660513110E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000360)=0.000000000000000E+00 (calc=0.124128328994191E+02 read=0.124128328994191E+02) Weight for this step=-.12220E+00 0.29569E+01 beta (00000361)=0.124128328994191E+02 gamma(00000361)=0.124128328994191E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 361 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000361)=0.000000000000000E+00 (calc=0.134328014588892E+02 read=0.134328014588892E+02) Weight for this step=0.11788E+00 -.25553E+01 beta (00000362)=0.134328014588892E+02 gamma(00000362)=0.134328014588892E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 362 z1= 1 -.104550119655683E-05 0.000000000000000E+00 z1= 2 0.262189967194812E-06 0.000000000000000E+00 z1= 3 -.191589725695719E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000362)=0.000000000000000E+00 (calc=0.128797663491533E+02 read=0.128797663491533E+02) Weight for this step=0.11886E+00 -.28569E+01 beta (00000363)=0.128797663491533E+02 gamma(00000363)=0.128797663491533E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 363 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000363)=0.000000000000000E+00 (calc=0.135103355849907E+02 read=0.135103355849907E+02) Weight for this step=-.11668E+00 0.25198E+01 beta (00000364)=0.135103355849907E+02 gamma(00000364)=0.135103355849907E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 364 z1= 1 0.108766126385727E-05 0.000000000000000E+00 z1= 2 -.247017739963564E-06 0.000000000000000E+00 z1= 3 0.201948524572165E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000364)=0.000000000000000E+00 (calc=0.122994594563962E+02 read=0.122994594563962E+02) Weight for this step=-.11915E+00 0.28456E+01 beta (00000365)=0.122994594563962E+02 gamma(00000365)=0.122994594563962E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 365 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000365)=0.000000000000000E+00 (calc=0.129062777509899E+02 read=0.129062777509899E+02) Weight for this step=0.12160E+00 -.26164E+01 beta (00000366)=0.129062777509899E+02 gamma(00000366)=0.129062777509899E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 366 z1= 1 -.114131212271879E-05 0.000000000000000E+00 z1= 2 0.272727355148388E-06 0.000000000000000E+00 z1= 3 -.211655244489869E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000366)=0.000000000000000E+00 (calc=0.127034506719825E+02 read=0.127034506719825E+02) Weight for this step=0.11992E+00 -.28445E+01 beta (00000367)=0.127034506719825E+02 gamma(00000367)=0.127034506719825E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 367 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000367)=0.000000000000000E+00 (calc=0.134766948016701E+02 read=0.134766948016701E+02) Weight for this step=-.11714E+00 0.25117E+01 beta (00000368)=0.134766948016701E+02 gamma(00000368)=0.134766948016701E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 368 z1= 1 0.117145710117208E-05 0.000000000000000E+00 z1= 2 -.231418201918142E-06 0.000000000000000E+00 z1= 3 0.215020004751112E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000368)=0.000000000000000E+00 (calc=0.125626419984281E+02 read=0.125626419984281E+02) Weight for this step=-.11892E+00 0.28033E+01 beta (00000369)=0.125626419984281E+02 gamma(00000369)=0.125626419984281E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 369 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000369)=0.000000000000000E+00 (calc=0.133692492072694E+02 read=0.133692492072694E+02) Weight for this step=0.11924E+00 -.25483E+01 beta (00000370)=0.133692492072694E+02 gamma(00000370)=0.133692492072694E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 370 z1= 1 -.121027425345908E-05 0.000000000000000E+00 z1= 2 0.249701066810091E-06 0.000000000000000E+00 z1= 3 -.212543001670369E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000370)=0.000000000000000E+00 (calc=0.128826973691614E+02 read=0.128826973691614E+02) Weight for this step=0.11777E+00 -.27589E+01 beta (00000371)=0.128826973691614E+02 gamma(00000371)=0.128826973691614E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 371 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000371)=0.000000000000000E+00 (calc=0.133106398040417E+02 read=0.133106398040417E+02) Weight for this step=-.11754E+00 0.25044E+01 beta (00000372)=0.133106398040417E+02 gamma(00000372)=0.133106398040417E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 372 z1= 1 0.127230000902942E-05 0.000000000000000E+00 z1= 2 -.187918472759237E-06 0.000000000000000E+00 z1= 3 0.214724156124336E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000372)=0.000000000000000E+00 (calc=0.128998889817155E+02 read=0.128998889817155E+02) Weight for this step=-.11995E+00 0.27934E+01 beta (00000373)=0.128998889817155E+02 gamma(00000373)=0.128998889817155E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 373 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000373)=0.000000000000000E+00 (calc=0.136448356973695E+02 read=0.136448356973695E+02) Weight for this step=0.11498E+00 -.24424E+01 beta (00000374)=0.136448356973695E+02 gamma(00000374)=0.136448356973695E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 374 z1= 1 -.130818793281590E-05 0.000000000000000E+00 z1= 2 0.217900948492732E-06 0.000000000000000E+00 z1= 3 -.207157295029114E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000374)=0.000000000000000E+00 (calc=0.128456387119421E+02 read=0.128456387119421E+02) Weight for this step=0.11910E+00 -.27580E+01 beta (00000375)=0.128456387119421E+02 gamma(00000375)=0.128456387119421E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 375 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000375)=0.000000000000000E+00 (calc=0.131827122335220E+02 read=0.131827122335220E+02) Weight for this step=-.11585E+00 0.24538E+01 beta (00000376)=0.131827122335220E+02 gamma(00000376)=0.131827122335220E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 376 z1= 1 0.137681166167560E-05 0.000000000000000E+00 z1= 2 -.143846616661517E-06 0.000000000000000E+00 z1= 3 0.196861542758153E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000376)=0.000000000000000E+00 (calc=0.130315133237395E+02 read=0.130315133237395E+02) Weight for this step=-.12199E+00 0.28094E+01 beta (00000377)=0.130315133237395E+02 gamma(00000377)=0.130315133237395E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 377 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000377)=0.000000000000000E+00 (calc=0.135748828858725E+02 read=0.135748828858725E+02) Weight for this step=0.11085E+00 -.23412E+01 beta (00000378)=0.135748828858725E+02 gamma(00000378)=0.135748828858725E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 378 z1= 1 -.143853514602966E-05 0.000000000000000E+00 z1= 2 0.184505637759605E-06 0.000000000000000E+00 z1= 3 -.176134882907832E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000378)=0.000000000000000E+00 (calc=0.125824292375232E+02 read=0.125824292375232E+02) Weight for this step=0.12263E+00 -.28098E+01 beta (00000379)=0.125824292375232E+02 gamma(00000379)=0.125824292375232E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 379 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000379)=0.000000000000000E+00 (calc=0.133817811372825E+02 read=0.133817811372825E+02) Weight for this step=-.11299E+00 0.23797E+01 beta (00000380)=0.133817811372825E+02 gamma(00000380)=0.133817811372825E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 380 z1= 1 0.146332171315804E-05 0.000000000000000E+00 z1= 2 -.101714448351789E-06 0.000000000000000E+00 z1= 3 0.147093627043692E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000380)=0.000000000000000E+00 (calc=0.131035197958078E+02 read=0.131035197958078E+02) Weight for this step=-.12101E+00 0.27584E+01 beta (00000381)=0.131035197958078E+02 gamma(00000381)=0.131035197958078E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 381 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000381)=0.000000000000000E+00 (calc=0.134408646313890E+02 read=0.134408646313890E+02) Weight for this step=0.10914E+00 -.22924E+01 beta (00000382)=0.134408646313890E+02 gamma(00000382)=0.134408646313890E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 382 z1= 1 -.153024463397396E-05 0.000000000000000E+00 z1= 2 0.112534338627844E-06 0.000000000000000E+00 z1= 3 -.127878084786829E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000382)=0.000000000000000E+00 (calc=0.129349967806138E+02 read=0.129349967806138E+02) Weight for this step=0.12346E+00 -.28008E+01 beta (00000383)=0.129349967806138E+02 gamma(00000383)=0.129349967806138E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 383 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000383)=0.000000000000000E+00 (calc=0.134944096150774E+02 read=0.134944096150774E+02) Weight for this step=-.10694E+00 0.22404E+01 beta (00000384)=0.134944096150774E+02 gamma(00000384)=0.134944096150774E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 384 z1= 1 0.155375714784442E-05 0.000000000000000E+00 z1= 2 -.229042659838363E-07 0.000000000000000E+00 z1= 3 0.111247077829812E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000384)=0.000000000000000E+00 (calc=0.126533462667551E+02 read=0.126533462667551E+02) Weight for this step=-.12369E+00 0.27933E+01 beta (00000385)=0.126533462667551E+02 gamma(00000385)=0.126533462667551E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 385 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000385)=0.000000000000000E+00 (calc=0.130169273392612E+02 read=0.130169273392612E+02) Weight for this step=0.10743E+00 -.22448E+01 beta (00000386)=0.130169273392612E+02 gamma(00000386)=0.130169273392612E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 386 z1= 1 -.160214891425394E-05 0.000000000000000E+00 z1= 2 -.295432998399271E-08 0.000000000000000E+00 z1= 3 -.969001939364590E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000386)=0.000000000000000E+00 (calc=0.129062920159321E+02 read=0.129062920159321E+02) Weight for this step=0.12581E+00 -.28282E+01 beta (00000387)=0.129062920159321E+02 gamma(00000387)=0.129062920159321E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 387 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000387)=0.000000000000000E+00 (calc=0.133571880844773E+02 read=0.133571880844773E+02) Weight for this step=-.10175E+00 0.21206E+01 beta (00000388)=0.133571880844773E+02 gamma(00000388)=0.133571880844773E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 388 z1= 1 0.162752450160705E-05 0.000000000000000E+00 z1= 2 0.106546567620091E-06 0.000000000000000E+00 z1= 3 0.840174353654485E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000388)=0.000000000000000E+00 (calc=0.125858504389911E+02 read=0.125858504389911E+02) Weight for this step=-.12671E+00 0.28366E+01 beta (00000389)=0.125858504389911E+02 gamma(00000389)=0.125858504389911E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 389 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000389)=0.000000000000000E+00 (calc=0.134760626930831E+02 read=0.134760626930831E+02) Weight for this step=0.10117E+00 -.21030E+01 beta (00000390)=0.134760626930831E+02 gamma(00000390)=0.134760626930831E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 390 z1= 1 -.158866200541786E-05 0.000000000000000E+00 z1= 2 -.172679434100450E-06 0.000000000000000E+00 z1= 3 -.731679091260820E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000390)=0.000000000000000E+00 (calc=0.129061939159410E+02 read=0.129061939159410E+02) Weight for this step=0.12341E+00 -.27514E+01 beta (00000391)=0.129061939159410E+02 gamma(00000391)=0.129061939159410E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 391 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000391)=0.000000000000000E+00 (calc=0.131950787381988E+02 read=0.131950787381988E+02) Weight for this step=-.99167E-01 0.20563E+01 beta (00000392)=0.131950787381988E+02 gamma(00000392)=0.131950787381988E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 392 z1= 1 0.161866909418006E-05 0.000000000000000E+00 z1= 2 0.273481709362139E-06 0.000000000000000E+00 z1= 3 0.745916347394434E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000392)=0.000000000000000E+00 (calc=0.126542969630551E+02 read=0.126542969630551E+02) Weight for this step=-.12578E+00 0.27932E+01 beta (00000393)=0.126542969630551E+02 gamma(00000393)=0.126542969630551E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 393 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000393)=0.000000000000000E+00 (calc=0.133841612018826E+02 read=0.133841612018826E+02) Weight for this step=0.96678E-01 -.19997E+01 beta (00000394)=0.133841612018826E+02 gamma(00000394)=0.133841612018826E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 394 z1= 1 -.158809474912972E-05 0.000000000000000E+00 z1= 2 -.339923594764929E-06 0.000000000000000E+00 z1= 3 -.722972182756612E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000394)=0.000000000000000E+00 (calc=0.126876807496503E+02 read=0.126876807496503E+02) Weight for this step=0.12380E+00 -.27386E+01 beta (00000395)=0.126876807496503E+02 gamma(00000395)=0.126876807496503E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 395 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000395)=0.000000000000000E+00 (calc=0.132038159500247E+02 read=0.132038159500247E+02) Weight for this step=-.95381E-01 0.19682E+01 beta (00000396)=0.132038159500247E+02 gamma(00000396)=0.132038159500247E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 396 z1= 1 0.158568431852732E-05 0.000000000000000E+00 z1= 2 0.417288723686404E-06 0.000000000000000E+00 z1= 3 0.634900169733527E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000396)=0.000000000000000E+00 (calc=0.127102686656377E+02 read=0.127102686656377E+02) Weight for this step=-.12384E+00 0.27292E+01 beta (00000397)=0.127102686656377E+02 gamma(00000397)=0.127102686656377E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 397 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000397)=0.000000000000000E+00 (calc=0.131579794101095E+02 read=0.131579794101095E+02) Weight for this step=0.92492E-01 -.19041E+01 beta (00000398)=0.131579794101095E+02 gamma(00000398)=0.131579794101095E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 398 z1= 1 -.159067119077743E-05 0.000000000000000E+00 z1= 2 -.502314794576571E-06 0.000000000000000E+00 z1= 3 -.431060924727038E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000398)=0.000000000000000E+00 (calc=0.126877647007954E+02 read=0.126877647007954E+02) Weight for this step=0.12437E+00 -.27310E+01 beta (00000399)=0.126877647007954E+02 gamma(00000399)=0.126877647007954E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 399 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000399)=0.000000000000000E+00 (calc=0.136083901818274E+02 read=0.136083901818274E+02) Weight for this step=-.89288E-01 0.18338E+01 beta (00000400)=0.136083901818274E+02 gamma(00000400)=0.136083901818274E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 400 z1= 1 0.154612990634607E-05 0.000000000000000E+00 z1= 2 0.526454854262478E-06 0.000000000000000E+00 z1= 3 0.189934818955049E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000400)=0.000000000000000E+00 (calc=0.128719400965169E+02 read=0.128719400965169E+02) Weight for this step=-.12039E+00 0.26345E+01 beta (00000401)=0.128719400965169E+02 gamma(00000401)=0.128719400965169E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 401 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000401)=0.000000000000000E+00 (calc=0.132282567864358E+02 read=0.132282567864358E+02) Weight for this step=0.88070E-01 -.18047E+01 beta (00000402)=0.132282567864358E+02 gamma(00000402)=0.132282567864358E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 402 z1= 1 -.156014468677084E-05 0.000000000000000E+00 z1= 2 -.612063286274591E-06 0.000000000000000E+00 z1= 3 0.835909071935613E-04 0.000000000000000E+00 Calculating total response charge density alpha(00000402)=0.000000000000000E+00 (calc=0.129674337641810E+02 read=0.129674337641810E+02) Weight for this step=0.12164E+00 -.26528E+01 beta (00000403)=0.129674337641810E+02 gamma(00000403)=0.129674337641810E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 403 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000403)=0.000000000000000E+00 (calc=0.133464177619936E+02 read=0.133464177619936E+02) Weight for this step=-.83496E-01 0.17071E+01 beta (00000404)=0.133464177619936E+02 gamma(00000404)=0.133464177619936E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 404 z1= 1 0.156719735088212E-05 0.000000000000000E+00 z1= 2 0.651033001011203E-06 0.000000000000000E+00 z1= 3 -.280802070311784E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000404)=0.000000000000000E+00 (calc=0.126603030847278E+02 read=0.126603030847278E+02) Weight for this step=-.12241E+00 0.26612E+01 beta (00000405)=0.126603030847278E+02 gamma(00000405)=0.126603030847278E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 405 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000405)=0.000000000000000E+00 (calc=0.135477418865919E+02 read=0.135477418865919E+02) Weight for this step=0.81481E-01 -.16620E+01 beta (00000406)=0.135477418865919E+02 gamma(00000406)=0.135477418865919E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 406 z1= 1 -.151492951209697E-05 0.000000000000000E+00 z1= 2 -.679922599172256E-06 0.000000000000000E+00 z1= 3 0.445979697657934E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000406)=0.000000000000000E+00 (calc=0.127114632111100E+02 read=0.127114632111100E+02) Weight for this step=0.11845E+00 -.25672E+01 beta (00000407)=0.127114632111100E+02 gamma(00000407)=0.127114632111100E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 407 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000407)=0.000000000000000E+00 (calc=0.130764906374438E+02 read=0.130764906374438E+02) Weight for this step=-.80540E-01 0.16392E+01 beta (00000408)=0.130764906374438E+02 gamma(00000408)=0.130764906374438E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 408 z1= 1 0.153820581013915E-05 0.000000000000000E+00 z1= 2 0.679293838960391E-06 0.000000000000000E+00 z1= 3 -.686985345386890E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000408)=0.000000000000000E+00 (calc=0.129445344361590E+02 read=0.129445344361590E+02) Weight for this step=-.11930E+00 0.25776E+01 beta (00000409)=0.129445344361590E+02 gamma(00000409)=0.129445344361590E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 409 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000409)=0.000000000000000E+00 (calc=0.133572084191845E+02 read=0.133572084191845E+02) Weight for this step=0.75129E-01 -.15256E+01 beta (00000410)=0.133572084191845E+02 gamma(00000410)=0.133572084191845E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 410 z1= 1 -.154846834304727E-05 0.000000000000000E+00 z1= 2 -.731872611127470E-06 0.000000000000000E+00 z1= 3 0.927556207086427E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000410)=0.000000000000000E+00 (calc=0.128095543370521E+02 read=0.128095543370521E+02) Weight for this step=0.11941E+00 -.25727E+01 beta (00000411)=0.128095543370521E+02 gamma(00000411)=0.128095543370521E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 411 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000411)=0.000000000000000E+00 (calc=0.138140877714809E+02 read=0.138140877714809E+02) Weight for this step=-.72038E-01 0.14593E+01 beta (00000412)=0.138140877714809E+02 gamma(00000412)=0.138140877714809E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 412 z1= 1 0.150531457786572E-05 0.000000000000000E+00 z1= 2 0.697426756417121E-06 0.000000000000000E+00 z1= 3 -.106207165302378E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000412)=0.000000000000000E+00 (calc=0.124499041269609E+02 read=0.124499041269609E+02) Weight for this step=-.11425E+00 0.24548E+01 beta (00000413)=0.124499041269609E+02 gamma(00000413)=0.124499041269609E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 413 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000413)=0.000000000000000E+00 (calc=0.133787623580096E+02 read=0.133787623580096E+02) Weight for this step=0.73727E-01 -.14902E+01 beta (00000414)=0.133787623580096E+02 gamma(00000414)=0.133787623580096E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 414 z1= 1 -.146616124358483E-05 0.000000000000000E+00 z1= 2 -.729310780607940E-06 0.000000000000000E+00 z1= 3 0.111328319800315E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000414)=0.000000000000000E+00 (calc=0.130605798032988E+02 read=0.130605798032988E+02) Weight for this step=0.11003E+00 -.23572E+01 beta (00000415)=0.130605798032988E+02 gamma(00000415)=0.130605798032988E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 415 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000415)=0.000000000000000E+00 (calc=0.135228159456446E+02 read=0.135228159456446E+02) Weight for this step=-.69828E-01 0.14084E+01 beta (00000416)=0.135228159456446E+02 gamma(00000416)=0.135228159456446E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 416 z1= 1 0.148758999376206E-05 0.000000000000000E+00 z1= 2 0.706530505301855E-06 0.000000000000000E+00 z1= 3 -.106537402068291E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000416)=0.000000000000000E+00 (calc=0.126275316721428E+02 read=0.126275316721428E+02) Weight for this step=-.10976E+00 0.23448E+01 beta (00000417)=0.126275316721428E+02 gamma(00000417)=0.126275316721428E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 417 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000417)=0.000000000000000E+00 (calc=0.138147940586449E+02 read=0.138147940586449E+02) Weight for this step=0.68903E-01 -.13867E+01 beta (00000418)=0.138147940586449E+02 gamma(00000418)=0.138147940586449E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 418 z1= 1 -.142187706116061E-05 0.000000000000000E+00 z1= 2 -.721984122864982E-06 0.000000000000000E+00 z1= 3 0.855613633287573E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000418)=0.000000000000000E+00 (calc=0.126621266527208E+02 read=0.126621266527208E+02) Weight for this step=0.10369E+00 -.22090E+01 beta (00000419)=0.126621266527208E+02 gamma(00000419)=0.126621266527208E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 419 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000419)=0.000000000000000E+00 (calc=0.135334961801957E+02 read=0.135334961801957E+02) Weight for this step=-.69641E-01 0.13987E+01 beta (00000420)=0.135334961801957E+02 gamma(00000420)=0.135334961801957E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 420 z1= 1 0.140528551216849E-05 0.000000000000000E+00 z1= 2 0.663971992409659E-06 0.000000000000000E+00 z1= 3 -.679847993761140E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000420)=0.000000000000000E+00 (calc=0.128427800532329E+02 read=0.128427800532329E+02) Weight for this step=-.10049E+00 0.21344E+01 beta (00000421)=0.128427800532329E+02 gamma(00000421)=0.128427800532329E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 421 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000421)=0.000000000000000E+00 (calc=0.130972381782816E+02 read=0.130972381782816E+02) Weight for this step=0.68098E-01 -.13651E+01 beta (00000422)=0.130972381782816E+02 gamma(00000422)=0.130972381782816E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 422 z1= 1 -.145381828561841E-05 0.000000000000000E+00 z1= 2 -.695378871064505E-06 0.000000000000000E+00 z1= 3 0.621482268328595E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000422)=0.000000000000000E+00 (calc=0.127561520897601E+02 read=0.127561520897601E+02) Weight for this step=0.10204E+00 -.21612E+01 beta (00000423)=0.127561520897601E+02 gamma(00000423)=0.127561520897601E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 423 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000423)=0.000000000000000E+00 (calc=0.136009993655058E+02 read=0.136009993655058E+02) Weight for this step=-.64513E-01 0.12907E+01 beta (00000424)=0.136009993655058E+02 gamma(00000424)=0.136009993655058E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 424 z1= 1 0.143490560604287E-05 0.000000000000000E+00 z1= 2 0.607623718265528E-06 0.000000000000000E+00 z1= 3 -.547571648853100E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000424)=0.000000000000000E+00 (calc=0.123518205979464E+02 read=0.123518205979464E+02) Weight for this step=-.98903E-01 0.20891E+01 beta (00000425)=0.123518205979464E+02 gamma(00000425)=0.123518205979464E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 425 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000425)=0.000000000000000E+00 (calc=0.137429613049663E+02 read=0.137429613049663E+02) Weight for this step=0.65627E-01 -.13106E+01 beta (00000426)=0.137429613049663E+02 gamma(00000426)=0.137429613049663E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 426 z1= 1 -.137279676169582E-05 0.000000000000000E+00 z1= 2 -.577960810490717E-06 0.000000000000000E+00 z1= 3 0.421943919713681E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000426)=0.000000000000000E+00 (calc=0.127408214535623E+02 read=0.127408214535623E+02) Weight for this step=0.92113E-01 -.19400E+01 beta (00000427)=0.127408214535623E+02 gamma(00000427)=0.127408214535623E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 427 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000427)=0.000000000000000E+00 (calc=0.133044973477618E+02 read=0.133044973477618E+02) Weight for this step=-.65904E-01 0.13140E+01 beta (00000428)=0.133044973477618E+02 gamma(00000428)=0.133044973477618E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 428 z1= 1 0.141782046936181E-05 0.000000000000000E+00 z1= 2 0.516868737816269E-06 0.000000000000000E+00 z1= 3 -.212762144393450E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000428)=0.000000000000000E+00 (calc=0.128353544095956E+02 read=0.128353544095956E+02) Weight for this step=-.91551E-01 0.19225E+01 beta (00000429)=0.128353544095956E+02 gamma(00000429)=0.128353544095956E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 429 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000429)=0.000000000000000E+00 (calc=0.132090497151444E+02 read=0.132090497151444E+02) Weight for this step=0.63494E-01 -.12640E+01 beta (00000430)=0.132090497151444E+02 gamma(00000430)=0.132090497151444E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 430 z1= 1 -.145982716117266E-05 0.000000000000000E+00 z1= 2 -.528339139896578E-06 0.000000000000000E+00 z1= 3 -.141288262773532E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000430)=0.000000000000000E+00 (calc=0.129472435777760E+02 read=0.129472435777760E+02) Weight for this step=0.92204E-01 -.19307E+01 beta (00000431)=0.129472435777760E+02 gamma(00000431)=0.129472435777760E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 431 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000431)=0.000000000000000E+00 (calc=0.135190703013985E+02 read=0.135190703013985E+02) Weight for this step=-.59967E-01 0.11919E+01 beta (00000432)=0.135190703013985E+02 gamma(00000432)=0.135190703013985E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 432 z1= 1 0.147052147750522E-05 0.000000000000000E+00 z1= 2 0.457657918679537E-06 0.000000000000000E+00 z1= 3 0.469821592272358E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000432)=0.000000000000000E+00 (calc=0.125895558447640E+02 read=0.125895558447640E+02) Weight for this step=-.91295E-01 0.19068E+01 beta (00000433)=0.125895558447640E+02 gamma(00000433)=0.125895558447640E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 433 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000433)=0.000000000000000E+00 (calc=0.137837506127573E+02 read=0.137837506127573E+02) Weight for this step=0.59496E-01 -.11808E+01 beta (00000434)=0.137837506127573E+02 gamma(00000434)=0.137837506127573E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 434 z1= 1 -.141464906198291E-05 0.000000000000000E+00 z1= 2 -.448470689291586E-06 0.000000000000000E+00 z1= 3 -.699539713353001E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000434)=0.000000000000000E+00 (calc=0.128837871725798E+02 read=0.128837871725798E+02) Weight for this step=0.86297E-01 -.17976E+01 beta (00000435)=0.128837871725798E+02 gamma(00000435)=0.128837871725798E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 435 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000435)=0.000000000000000E+00 (calc=0.132266147154652E+02 read=0.132266147154652E+02) Weight for this step=-.59128E-01 0.11720E+01 beta (00000436)=0.132266147154652E+02 gamma(00000436)=0.132266147154652E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 436 z1= 1 0.147273113910464E-05 0.000000000000000E+00 z1= 2 0.406513846249292E-06 0.000000000000000E+00 z1= 3 0.900608087873407E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000436)=0.000000000000000E+00 (calc=0.129067997987740E+02 read=0.129067997987740E+02) Weight for this step=-.87075E-01 0.18090E+01 beta (00000437)=0.129067997987740E+02 gamma(00000437)=0.129067997987740E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 437 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000437)=0.000000000000000E+00 (calc=0.128547229416295E+02 read=0.128547229416295E+02) Weight for this step=0.56037E-01 -.11093E+01 beta (00000438)=0.128547229416295E+02 gamma(00000438)=0.128547229416295E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 438 z1= 1 -.157848638437079E-05 0.000000000000000E+00 z1= 2 -.416039479493124E-06 0.000000000000000E+00 z1= 3 -.935635257585585E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000438)=0.000000000000000E+00 (calc=0.127824543107614E+02 read=0.127824543107614E+02) Weight for this step=0.90368E-01 -.18728E+01 beta (00000439)=0.127824543107614E+02 gamma(00000439)=0.127824543107614E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 439 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000439)=0.000000000000000E+00 (calc=0.133184571088201E+02 read=0.133184571088201E+02) Weight for this step=-.51579E-01 0.10196E+01 beta (00000440)=0.133184571088201E+02 gamma(00000440)=0.133184571088201E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 440 z1= 1 0.160455407259539E-05 0.000000000000000E+00 z1= 2 0.386224118476333E-06 0.000000000000000E+00 z1= 3 0.810786448013896E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000440)=0.000000000000000E+00 (calc=0.124654903111043E+02 read=0.124654903111043E+02) Weight for this step=-.89343E-01 0.18476E+01 beta (00000441)=0.124654903111043E+02 gamma(00000441)=0.124654903111043E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 441 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000441)=0.000000000000000E+00 (calc=0.134802894187853E+02 read=0.134802894187853E+02) Weight for this step=0.50269E-01 -.99237E+00 beta (00000442)=0.134802894187853E+02 gamma(00000442)=0.134802894187853E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 442 z1= 1 -.157824705911011E-05 0.000000000000000E+00 z1= 2 -.370504769232568E-06 0.000000000000000E+00 z1= 3 -.516723672055309E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000442)=0.000000000000000E+00 (calc=0.125905872635202E+02 read=0.125905872635202E+02) Weight for this step=0.85132E-01 -.17567E+01 beta (00000443)=0.125905872635202E+02 gamma(00000443)=0.125905872635202E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 443 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000443)=0.000000000000000E+00 (calc=0.133373843698145E+02 read=0.133373843698145E+02) Weight for this step=-.49256E-01 0.97117E+00 beta (00000444)=0.133373843698145E+02 gamma(00000444)=0.133373843698145E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 444 z1= 1 0.159140581428553E-05 0.000000000000000E+00 z1= 2 0.358438444400468E-06 0.000000000000000E+00 z1= 3 0.180811874267587E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000444)=0.000000000000000E+00 (calc=0.132098631454005E+02 read=0.132098631454005E+02) Weight for this step=-.82855E-01 0.17060E+01 beta (00000445)=0.132098631454005E+02 gamma(00000445)=0.132098631454005E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 445 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000445)=0.000000000000000E+00 (calc=0.130285525989132E+02 read=0.130285525989132E+02) Weight for this step=0.45496E-01 -.89602E+00 beta (00000446)=0.130285525989132E+02 gamma(00000446)=0.130285525989132E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 446 z1= 1 -.171096945112982E-05 0.000000000000000E+00 z1= 2 -.370815401022607E-06 0.000000000000000E+00 z1= 3 0.129774841020959E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000446)=0.000000000000000E+00 (calc=0.129522345513029E+02 read=0.129522345513029E+02) Weight for this step=0.86363E-01 -.17747E+01 beta (00000447)=0.129522345513029E+02 gamma(00000447)=0.129522345513029E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 447 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000447)=0.000000000000000E+00 (calc=0.132092077659276E+02 read=0.132092077659276E+02) Weight for this step=-.41262E-01 0.81161E+00 beta (00000448)=0.132092077659276E+02 gamma(00000448)=0.132092077659276E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 448 z1= 1 0.176586606393902E-05 0.000000000000000E+00 z1= 2 0.391112146086664E-06 0.000000000000000E+00 z1= 3 -.343660162654778E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000448)=0.000000000000000E+00 (calc=0.129489694678041E+02 read=0.129489694678041E+02) Weight for this step=-.86789E-01 0.17804E+01 beta (00000449)=0.129489694678041E+02 gamma(00000449)=0.129489694678041E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 449 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000449)=0.000000000000000E+00 (calc=0.136504025432705E+02 read=0.136504025432705E+02) Weight for this step=0.37567E-01 -.73792E+00 beta (00000450)=0.136504025432705E+02 gamma(00000450)=0.136504025432705E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 450 z1= 1 -.174801863420267E-05 0.000000000000000E+00 z1= 2 -.377850785974630E-06 0.000000000000000E+00 z1= 3 0.462101670709630E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000450)=0.000000000000000E+00 (calc=0.124501730117260E+02 read=0.124501730117260E+02) Weight for this step=0.84185E-01 -.17243E+01 beta (00000451)=0.124501730117260E+02 gamma(00000451)=0.124501730117260E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 451 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000451)=0.000000000000000E+00 (calc=0.137434202664513E+02 read=0.137434202664513E+02) Weight for this step=-.36624E-01 0.71841E+00 beta (00000452)=0.137434202664513E+02 gamma(00000452)=0.137434202664513E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 452 z1= 1 0.166197233217834E-05 0.000000000000000E+00 z1= 2 0.375300470796406E-06 0.000000000000000E+00 z1= 3 -.621547591021523E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000452)=0.000000000000000E+00 (calc=0.123492923787822E+02 read=0.123492923787822E+02) Weight for this step=-.78060E-01 0.15963E+01 beta (00000453)=0.123492923787822E+02 gamma(00000453)=0.123492923787822E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 453 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000453)=0.000000000000000E+00 (calc=0.136342946054680E+02 read=0.136342946054680E+02) Weight for this step=0.36491E-01 -.71490E+00 beta (00000454)=0.136342946054680E+02 gamma(00000454)=0.136342946054680E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 454 z1= 1 -.159864766387127E-05 0.000000000000000E+00 z1= 2 -.313741836252632E-06 0.000000000000000E+00 z1= 3 0.740762086410401E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000454)=0.000000000000000E+00 (calc=0.124948952471787E+02 read=0.124948952471787E+02) Weight for this step=0.72507E-01 -.14802E+01 beta (00000455)=0.124948952471787E+02 gamma(00000455)=0.124948952471787E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 455 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000455)=0.000000000000000E+00 (calc=0.136130030454256E+02 read=0.136130030454256E+02) Weight for this step=-.35902E-01 0.70255E+00 beta (00000456)=0.136130030454256E+02 gamma(00000456)=0.136130030454256E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 456 z1= 1 0.155587790998547E-05 0.000000000000000E+00 z1= 2 0.305237187649219E-06 0.000000000000000E+00 z1= 3 -.936690019165656E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000456)=0.000000000000000E+00 (calc=0.127298041810865E+02 read=0.127298041810865E+02) Weight for this step=-.68330E-01 0.13924E+01 beta (00000457)=0.127298041810865E+02 gamma(00000457)=0.127298041810865E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 457 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000457)=0.000000000000000E+00 (calc=0.134663452736753E+02 read=0.134663452736753E+02) Weight for this step=0.34770E-01 -.67970E+00 beta (00000458)=0.134663452736753E+02 gamma(00000458)=0.134663452736753E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 458 z1= 1 -.157647312997784E-05 0.000000000000000E+00 z1= 2 -.225506728555565E-06 0.000000000000000E+00 z1= 3 0.110717239958834E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000458)=0.000000000000000E+00 (calc=0.129360974683917E+02 read=0.129360974683917E+02) Weight for this step=0.66333E-01 -.13492E+01 beta (00000459)=0.129360974683917E+02 gamma(00000459)=0.129360974683917E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 459 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000459)=0.000000000000000E+00 (calc=0.134362650812136E+02 read=0.134362650812136E+02) Weight for this step=-.32734E-01 0.63929E+00 beta (00000460)=0.134362650812136E+02 gamma(00000460)=0.134362650812136E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 460 z1= 1 0.160263641219867E-05 0.000000000000000E+00 z1= 2 0.222458834174891E-06 0.000000000000000E+00 z1= 3 -.121671490165785E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000460)=0.000000000000000E+00 (calc=0.127149981396893E+02 read=0.127149981396893E+02) Weight for this step=-.65506E-01 0.13302E+01 beta (00000461)=0.127149981396893E+02 gamma(00000461)=0.127149981396893E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 461 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000461)=0.000000000000000E+00 (calc=0.133073050017409E+02 read=0.133073050017409E+02) Weight for this step=0.31114E-01 -.60708E+00 beta (00000462)=0.133073050017409E+02 gamma(00000462)=0.133073050017409E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 462 z1= 1 -.163684490456153E-05 0.000000000000000E+00 z1= 2 -.116212889931754E-06 0.000000000000000E+00 z1= 3 0.123513012779260E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000462)=0.000000000000000E+00 (calc=0.130288464339842E+02 read=0.130288464339842E+02) Weight for this step=0.64167E-01 -.13008E+01 beta (00000463)=0.130288464339842E+02 gamma(00000463)=0.130288464339842E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 463 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000463)=0.000000000000000E+00 (calc=0.134211024300303E+02 read=0.134211024300303E+02) Weight for this step=-.28455E-01 0.55471E+00 beta (00000464)=0.134211024300303E+02 gamma(00000464)=0.134211024300303E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 464 z1= 1 0.169540029383111E-05 0.000000000000000E+00 z1= 2 0.963341908549417E-07 0.000000000000000E+00 z1= 3 -.114486027074273E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000464)=0.000000000000000E+00 (calc=0.126554501553061E+02 read=0.126554501553061E+02) Weight for this step=-.63720E-01 0.12899E+01 beta (00000465)=0.126554501553061E+02 gamma(00000465)=0.126554501553061E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 465 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000465)=0.000000000000000E+00 (calc=0.134457786287963E+02 read=0.134457786287963E+02) Weight for this step=0.26778E-01 -.52155E+00 beta (00000466)=0.134457786287963E+02 gamma(00000466)=0.134457786287963E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 466 z1= 1 -.170621634420430E-05 0.000000000000000E+00 z1= 2 0.102729812391164E-07 0.000000000000000E+00 z1= 3 0.100054173108437E-02 0.000000000000000E+00 Calculating total response charge density alpha(00000466)=0.000000000000000E+00 (calc=0.128140988756160E+02 read=0.128140988756160E+02) Weight for this step=0.61317E-01 -.12394E+01 beta (00000467)=0.128140988756160E+02 gamma(00000467)=0.128140988756160E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 467 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000467)=0.000000000000000E+00 (calc=0.136873258289409E+02 read=0.136873258289409E+02) Weight for this step=-.24869E-01 0.48395E+00 beta (00000468)=0.136873258289409E+02 gamma(00000468)=0.136873258289409E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 468 z1= 1 0.169618807525545E-05 0.000000000000000E+00 z1= 2 -.431385434405268E-08 0.000000000000000E+00 z1= 3 -.837464911866845E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000468)=0.000000000000000E+00 (calc=0.126931687259611E+02 read=0.126931687259611E+02) Weight for this step=-.58630E-01 0.11835E+01 beta (00000469)=0.126931687259611E+02 gamma(00000469)=0.126931687259611E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 469 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000469)=0.000000000000000E+00 (calc=0.136810377833230E+02 read=0.136810377833230E+02) Weight for this step=0.23700E-01 -.46083E+00 beta (00000470)=0.136810377833230E+02 gamma(00000470)=0.136810377833230E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 470 z1= 1 -.168191801045716E-05 0.000000000000000E+00 z1= 2 0.106841020811738E-06 0.000000000000000E+00 z1= 3 0.602729214429290E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000470)=0.000000000000000E+00 (calc=0.127563616568712E+02 read=0.127563616568712E+02) Weight for this step=0.55564E-01 -.11201E+01 beta (00000471)=0.127563616568712E+02 gamma(00000471)=0.127563616568712E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 471 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000471)=0.000000000000000E+00 (calc=0.133838613102552E+02 read=0.133838613102552E+02) Weight for this step=-.22479E-01 0.43676E+00 beta (00000472)=0.133838613102552E+02 gamma(00000472)=0.133838613102552E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 472 z1= 1 0.170653570927986E-05 0.000000000000000E+00 z1= 2 -.116824585449276E-06 0.000000000000000E+00 z1= 3 -.376437853446920E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000472)=0.000000000000000E+00 (calc=0.126367610178153E+02 read=0.126367610178153E+02) Weight for this step=-.54091E-01 0.10889E+01 beta (00000473)=0.126367610178153E+02 gamma(00000473)=0.126367610178153E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 473 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000473)=0.000000000000000E+00 (calc=0.134964324776565E+02 read=0.134964324776565E+02) Weight for this step=0.20920E-01 -.40618E+00 beta (00000474)=0.134964324776565E+02 gamma(00000474)=0.134964324776565E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 474 z1= 1 -.170035166481119E-05 0.000000000000000E+00 z1= 2 0.192608232536372E-06 0.000000000000000E+00 z1= 3 0.138260351664357E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000474)=0.000000000000000E+00 (calc=0.127392766365606E+02 read=0.127392766365606E+02) Weight for this step=0.51691E-01 -.10393E+01 beta (00000475)=0.127392766365606E+02 gamma(00000475)=0.127392766365606E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 475 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000475)=0.000000000000000E+00 (calc=0.133043317721145E+02 read=0.133043317721145E+02) Weight for this step=-.19426E-01 0.37692E+00 beta (00000476)=0.133043317721145E+02 gamma(00000476)=0.133043317721145E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 476 z1= 1 0.173694136534083E-05 0.000000000000000E+00 z1= 2 -.185314599095675E-06 0.000000000000000E+00 z1= 3 -.337873353447845E-05 0.000000000000000E+00 Calculating total response charge density alpha(00000476)=0.000000000000000E+00 (calc=0.126415261663525E+02 read=0.126415261663525E+02) Weight for this step=-.50479E-01 0.10137E+01 beta (00000477)=0.126415261663525E+02 gamma(00000477)=0.126415261663525E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 477 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000477)=0.000000000000000E+00 (calc=0.133306251775365E+02 read=0.133306251775365E+02) Weight for this step=0.17750E-01 -.34420E+00 beta (00000478)=0.133306251775365E+02 gamma(00000478)=0.133306251775365E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 478 z1= 1 -.176240194921327E-05 0.000000000000000E+00 z1= 2 0.234582904364098E-06 0.000000000000000E+00 z1= 3 -.894890375254557E-04 0.000000000000000E+00 Calculating total response charge density alpha(00000478)=0.000000000000000E+00 (calc=0.126280449578772E+02 read=0.126280449578772E+02) Weight for this step=0.48767E-01 -.97818E+00 beta (00000479)=0.126280449578772E+02 gamma(00000479)=0.126280449578772E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 479 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000479)=0.000000000000000E+00 (calc=0.133935339587214E+02 read=0.133935339587214E+02) Weight for this step=-.16132E-01 0.31264E+00 beta (00000480)=0.133935339587214E+02 gamma(00000480)=0.133935339587214E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 480 z1= 1 0.178966230798654E-05 0.000000000000000E+00 z1= 2 -.259719269926021E-06 0.000000000000000E+00 z1= 3 0.171353638887217E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000480)=0.000000000000000E+00 (calc=0.126439244074454E+02 read=0.126439244074454E+02) Weight for this step=-.46792E-01 0.93755E+00 beta (00000481)=0.126439244074454E+02 gamma(00000481)=0.126439244074454E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 481 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000481)=0.000000000000000E+00 (calc=0.134762750745675E+02 read=0.134762750745675E+02) Weight for this step=0.14592E-01 -.28264E+00 beta (00000482)=0.134762750745675E+02 gamma(00000482)=0.134762750745675E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 482 z1= 1 -.182174448691731E-05 0.000000000000000E+00 z1= 2 0.286513547364739E-06 0.000000000000000E+00 z1= 3 -.275199578778312E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000482)=0.000000000000000E+00 (calc=0.127040144432327E+02 read=0.127040144432327E+02) Weight for this step=0.44632E-01 -.89337E+00 beta (00000483)=0.127040144432327E+02 gamma(00000483)=0.127040144432327E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 483 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000483)=0.000000000000000E+00 (calc=0.136555001935686E+02 read=0.136555001935686E+02) Weight for this step=-.13109E-01 0.25380E+00 beta (00000484)=0.136555001935686E+02 gamma(00000484)=0.136555001935686E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 484 z1= 1 0.182997233333815E-05 0.000000000000000E+00 z1= 2 -.296439878380030E-06 0.000000000000000E+00 z1= 3 0.373812420015648E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000484)=0.000000000000000E+00 (calc=0.126719432145867E+02 read=0.126719432145867E+02) Weight for this step=-.42169E-01 0.84329E+00 beta (00000485)=0.126719432145867E+02 gamma(00000485)=0.126719432145867E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 485 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000485)=0.000000000000000E+00 (calc=0.132368047448267E+02 read=0.132368047448267E+02) Weight for this step=0.11882E-01 -.22994E+00 beta (00000486)=0.132368047448267E+02 gamma(00000486)=0.132368047448267E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 486 z1= 1 -.189899447369243E-05 0.000000000000000E+00 z1= 2 0.325793361430067E-06 0.000000000000000E+00 z1= 3 -.477744480752816E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000486)=0.000000000000000E+00 (calc=0.124437261861195E+02 read=0.124437261861195E+02) Weight for this step=0.40974E-01 -.81867E+00 beta (00000487)=0.124437261861195E+02 gamma(00000487)=0.124437261861195E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 487 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000487)=0.000000000000000E+00 (calc=0.134512532092274E+02 read=0.134512532092274E+02) Weight for this step=-.10418E-01 0.20153E+00 beta (00000488)=0.134512532092274E+02 gamma(00000488)=0.134512532092274E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 488 z1= 1 0.192142727328621E-05 0.000000000000000E+00 z1= 2 -.401840809781363E-06 0.000000000000000E+00 z1= 3 0.507452897499268E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000488)=0.000000000000000E+00 (calc=0.128384028478170E+02 read=0.128384028478170E+02) Weight for this step=-.38427E-01 0.76716E+00 beta (00000489)=0.128384028478170E+02 gamma(00000489)=0.128384028478170E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 489 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000489)=0.000000000000000E+00 (calc=0.132658282283567E+02 read=0.132658282283567E+02) Weight for this step=0.88960E-02 -.17204E+00 beta (00000490)=0.132658282283567E+02 gamma(00000490)=0.132658282283567E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 490 z1= 1 -.202337340542727E-05 0.000000000000000E+00 z1= 2 0.406467269782108E-06 0.000000000000000E+00 z1= 3 -.576794970680383E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000490)=0.000000000000000E+00 (calc=0.125999547977457E+02 read=0.125999547977457E+02) Weight for this step=0.37641E-01 -.75093E+00 beta (00000491)=0.125999547977457E+02 gamma(00000491)=0.125999547977457E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 491 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000491)=0.000000000000000E+00 (calc=0.134509578383365E+02 read=0.134509578383365E+02) Weight for this step=-.73510E-02 0.14212E+00 beta (00000492)=0.134509578383365E+02 gamma(00000492)=0.134509578383365E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 492 z1= 1 0.206698168493723E-05 0.000000000000000E+00 z1= 2 -.469258414710296E-06 0.000000000000000E+00 z1= 3 0.649007795192801E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000492)=0.000000000000000E+00 (calc=0.127242711727466E+02 read=0.127242711727466E+02) Weight for this step=-.35628E-01 0.71033E+00 beta (00000493)=0.127242711727466E+02 gamma(00000493)=0.127242711727466E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 493 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000493)=0.000000000000000E+00 (calc=0.132863157154913E+02 read=0.132863157154913E+02) Weight for this step=0.58821E-02 -.11369E+00 beta (00000494)=0.132863157154913E+02 gamma(00000494)=0.132863157154913E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 494 z1= 1 -.214886609022294E-05 0.000000000000000E+00 z1= 2 0.445621500224454E-06 0.000000000000000E+00 z1= 3 -.798422898724474E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000494)=0.000000000000000E+00 (calc=0.124537358460341E+02 read=0.124537358460341E+02) Weight for this step=0.34419E-01 -.68589E+00 beta (00000495)=0.124537358460341E+02 gamma(00000495)=0.124537358460341E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 495 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000495)=0.000000000000000E+00 (calc=0.134982169354984E+02 read=0.134982169354984E+02) Weight for this step=-.44111E-02 0.85247E-01 beta (00000496)=0.134982169354984E+02 gamma(00000496)=0.134982169354984E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 496 z1= 1 0.216983142513631E-05 0.000000000000000E+00 z1= 2 -.552501027290854E-06 0.000000000000000E+00 z1= 3 0.848444396267198E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000496)=0.000000000000000E+00 (calc=0.128385346915888E+02 read=0.128385346915888E+02) Weight for this step=-.31976E-01 0.63695E+00 beta (00000497)=0.128385346915888E+02 gamma(00000497)=0.128385346915888E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 497 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000497)=0.000000000000000E+00 (calc=0.133352145988185E+02 read=0.133352145988185E+02) Weight for this step=0.29578E-02 -.57153E-01 beta (00000498)=0.133352145988185E+02 gamma(00000498)=0.133352145988185E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 498 z1= 1 -.225933286496682E-05 0.000000000000000E+00 z1= 2 0.500109016789477E-06 0.000000000000000E+00 z1= 3 -.918959575886864E-03 0.000000000000000E+00 Calculating total response charge density alpha(00000498)=0.000000000000000E+00 (calc=0.126817394774924E+02 read=0.126817394774924E+02) Weight for this step=0.30935E-01 -.61603E+00 beta (00000499)=0.126817394774924E+02 gamma(00000499)=0.126817394774924E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 499 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000499)=0.000000000000000E+00 (calc=0.134573525727283E+02 read=0.134573525727283E+02) Weight for this step=-.14648E-02 0.28303E-01 beta (00000500)=0.134573525727283E+02 gamma(00000500)=0.134573525727283E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 500 z1= 1 0.231666516413919E-05 0.000000000000000E+00 z1= 2 -.662624369048015E-06 0.000000000000000E+00 z1= 3 0.105297229333066E-02 0.000000000000000E+00 alpha(00000500)=0.000000000000000E+00 (calc=0.127046759927261E+02 read=0.127046759927261E+02) Weight for this step=-.29225E-01 0.58190E+00 beta (00000501)=0.127046759927261E+02 gamma(00000501)=0.127046759927261E+02 lr_apply_liouvillian: not applying interaction lr_apply_liouvillian: applying interaction: normal Writing Cube file for response charge density Writing Cube file for response charge density End of Lanczos iterations Finished linear response calculation... lr_main : 648.30s CPU 691.20s WALL ( 1 calls) lr_solve_e : 3.98s CPU 4.18s WALL ( 1 calls) one_step : 638.58s CPU 678.17s WALL ( 1500 calls) lr_apply : 578.85s CPU 613.63s WALL ( 3006 calls) lr_apply_int : 444.66s CPU 470.71s WALL ( 1503 calls) lr_apply_no : 134.18s CPU 142.92s WALL ( 1503 calls) lr_apply : 578.85s CPU 613.63s WALL ( 3006 calls) h_psi : 267.27s CPU 282.54s WALL ( 3006 calls) lr_calc_dens : 129.20s CPU 137.41s WALL ( 2253 calls) lr_ortho : 3.73s CPU 3.95s WALL ( 3000 calls) interaction : 75.01s CPU 79.60s WALL ( 1503 calls) lr_dot : 1.64s CPU 1.80s WALL ( 3753 calls) US routines lr_sm1_psi : 1.05s CPU 1.15s WALL ( 3006 calls) General routines calbec : 3.19s CPU 3.47s WALL ( 4605 calls) fft : 107.12s CPU 114.48s WALL ( 3009 calls) fftw : 377.32s CPU 399.70s WALL ( 19714 calls) interpolate : 2.21s CPU 2.36s WALL ( 1503 calls) davcio : 0.00s CPU 0.08s WALL ( 59 calls) Parallel routines fft_scatter : 155.94s CPU 166.97s WALL ( 22723 calls) post-process : 4.84s CPU 7.19s WALL ( 12 calls) TDDFPT : 10m48.31s CPU 11m31.23s WALL This run was terminated on: 15: 4:55 13Jan2012 =------------------------------------------------------------------------------= JOB DONE. =------------------------------------------------------------------------------= TDDFPT/Examples/CH4-PR/CH4-PR.tddfpt_pp-in0000644000175000017500000000027112341371500016001 0ustar mbamba&lr_input prefix='ch4-pr', outdir='./out', itermax=500 itermax0=500 extrapolation="no" epsil=0.001 end=0.75d0 increment=0.0001d0 start=0.55d0 ipol=4 verbosity=1 / TDDFPT/Examples/CH4-PR/CH4-PR.tddfpt-in-s20000644000175000017500000000032312341371500015622 0ustar mbamba&lr_input prefix="ch4-pr", outdir='./out', restart_step=250, / &lr_control itermax=500, ipol=4 charge_response=1 / &lr_post omeg=0.6546 epsil=0.001 w_T_npol=3 plot_type=3 / TDDFPT/Examples/CH4-PR/CH4-PR.tddfpt_pp-ref0000644000175000017500000000335212341371500016152 0ustar mbamba Program TDDFPT_PP v.4.2 starts on 12Sep2010 at 23:18:13 This program is part of the open-source Quantum ESPRESSO suite for quantum simulation of materials; please cite "P. Giannozzi et al., J. Phys.:Condens. Matter 21 395502 (2009); URL http://www.quantum-espresso.org", in publications or presentations arising from this work. More details at http://www.quantum-espresso.org/wiki/index.php/Citing_Quantum-ESPRESSO Parallel version (MPI), running on 1 processors Reading 500 Lanczos steps for direction 1 500 steps will be considered Reading 500 Lanczos steps for direction 2 500 steps will be considered Reading 500 Lanczos steps for direction 3 500 steps will be considered Data ready, starting to calculate observables Broadening = 0.00100000 Ry Output file name: ch4-pr.plot alpha:absorption coefficient CHI:susceptibility tensor Functions are reported as a function of hbar.omega (Ry) Static Polarizability Tensor: chi_1_1= 0.238993229105366E+01 + i0.000000000000000E+00 chi_2_1= 0.246212302127900E-05 + i0.000000000000000E+00 chi_3_1= -.126345391136001E-05 + i0.000000000000000E+00 chi_1_2= 0.246212302103447E-05 + i0.000000000000000E+00 chi_2_2= 0.238993226836416E+01 + i0.000000000000000E+00 chi_3_2= -.609468691431850E-06 + i0.000000000000000E+00 chi_1_3= -.126345391116435E-05 + i0.000000000000000E+00 chi_2_3= -.609468691343730E-06 + i0.000000000000000E+00 chi_3_3= 0.238993293314604E+01 + i0.000000000000000E+00 Possible peak at 0.65460000 Ry; Intensity= 0.53E+02 Possible peak at 0.70390000 Ry; Intensity= 0.25E+02 TDDFPT/Examples/CH4-PR/Makefile0000644000175000017500000000072712341371500014240 0ustar mbambainclude ../make.sys NAME = CH4-PR default : all all : stage1 stage2 stage1: $(NAME).pw-out $(NAME).tddfpt-out $(NAME).tddfpt_pp-out $(check_pw) $(NAME).pw-out $(NAME).pw-ref $(check_tddfpt) $(NAME).tddfpt-out $(NAME).tddfpt-ref stage2: $(NAME).tddfpt-out-s2 $(check_tddfpt) $(NAME).tddfpt-out-s2 $(NAME).tddfpt-ref-s2 clean : - /bin/rm -rf $(NAME).pw-out $(NAME).tddfpt-out $(NAME).tddfpt_pp-out $(NAME).tddfpt-st-out *.plot out/* $(NAME).tddfpt-out-s2 *.cube TDDFPT/Examples/CH4-DAV/0000755000175000017500000000000012341371517012673 5ustar mbambaTDDFPT/Examples/CH4-DAV/CH4.dav-in0000644000175000017500000000060312341371500014340 0ustar mbamba&lr_input prefix="ch4", outdir='./out', restart_step=250, / &lr_dav num_eign=20 num_init=40 num_basis_max=300 residue_conv_thr=1.0E-4 start=0.4 finish=1.5 step=0.0002 broadening=0.005 reference=0.5 p_nbnd_occ=4 p_nbnd_virt=15 poor_of_ram=.false. poor_of_ram2=.false. / TDDFPT/Examples/CH4-DAV/ch4.eigen-ref0000644000175000017500000000405312341371500015126 0ustar mbamba# Energy(Ry) total X Y Z 0.64132425E+00 0.32038578E-01 0.56630631E-02 0.37925686E-02 0.22582946E-01 0.64132629E+00 0.32039188E-01 0.13980023E-01 0.18041860E-01 0.17304931E-04 0.64132860E+00 0.32091944E-01 0.12419075E-01 0.10217344E-01 0.94555254E-02 0.73765484E+00 0.19395914E-01 0.41219640E-02 0.17756632E-02 0.13498287E-01 0.73765693E+00 0.19397247E-01 0.69034098E-02 0.12464470E-01 0.29366921E-04 0.73765816E+00 0.19483147E-01 0.84105499E-02 0.51777300E-02 0.58948675E-02 0.74536346E+00 0.43374125E-02 0.17546929E-02 0.21620807E-02 0.42063898E-03 0.74536499E+00 0.43281470E-02 0.35161285E-03 0.15040335E-02 0.24725007E-02 0.74536654E+00 0.43295530E-02 0.22261050E-02 0.66568299E-03 0.14377650E-02 0.74605644E+00 0.92113142E-08 0.46141888E-09 0.54995201E-10 0.86949001E-08 0.74605765E+00 0.50630851E-08 0.29078952E-09 0.31862096E-08 0.15860860E-08 0.74785473E+00 0.11546982E-08 0.28904220E-09 0.59010626E-09 0.27554974E-09 0.74785599E+00 0.90316342E-09 0.48373589E-09 0.34662229E-09 0.72805235E-10 0.74785692E+00 0.50873226E-09 0.32632188E-09 0.18241034E-09 0.46123891E-16 0.75706960E+00 0.53716447E-02 0.26622608E-02 0.28201941E-03 0.24273645E-02 0.75707119E+00 0.53698822E-02 0.74109486E-03 0.25426003E-02 0.20861870E-02 0.75707479E+00 0.53801790E-02 0.19718500E-02 0.25508203E-02 0.85750872E-03 0.75785258E+00 0.35953137E-07 0.10942832E-08 0.23280367E-07 0.11578487E-07 0.75785323E+00 0.35440833E-07 0.28003079E-07 0.45678421E-08 0.28699122E-08 0.75785575E+00 0.12271601E-07 0.91970091E-08 0.30745566E-08 0.35049407E-13 TDDFPT/Examples/CH4-DAV/CH4.dav-ref0000644000175000017500000032115012341371500014511 0ustar mbamba Program turboTDDFT v.5.0.2 (svn rev. 10263) starts on 22May2013 at 18:47:38 This program is part of the open-source Quantum ESPRESSO suite for quantum simulation of materials; please cite "P. Giannozzi et al., J. Phys.:Condens. Matter 21 395502 (2009); URL http://www.quantum-espresso.org", in publications or presentations arising from this work. More details at http://www.quantum-espresso.org/quote Parallel version (MPI), running on 1 processors Info: using nr1, nr2, nr3 values from input Info: using nr1s, nr2s, nr3s values from input IMPORTANT: XC functional enforced from input : Exchange-correlation = SLA PZ NOGX NOGC ( 1 1 0 0 0) EXX-fraction = 0.00 Any further DFT definition will be discarded Please, verify this is what you really want file H.pz-vbc.UPF: wavefunction(s) 1S renormalized G-vector sticks info -------------------- sticks: dense smooth PW G-vecs: dense smooth PW Sum 3181 3181 793 135043 135043 16879 Tot 1591 1591 397 Subspace diagonalization in iterative solution of the eigenvalue problem: a serial algorithm will be used Allocating 16 extra bands for projection ---------------------------------------- Welcome using turbo-davidson. For this moment you can report bugs to Xiaochuan Ge: xiaochuan.ge@sissa.it We appreciate a lot your help to make us improve. ---------------------------------------- Virt read Gamma point algorithm lr_wfcinit_spectrum: finished lr_solve_e Num of eigen values= 20 Allocating parameters for davidson ... Finished allocating parameters. Initiating variables for davidson ... Lowest energy electron-hole pairs are used as initial vectors ... Calculating the electron-hole pairs for initiating trial vectors ... 1 4 1 0.639081935411 2 3 1 0.639085190539 3 2 1 0.639087274576 4 4 2 0.734003492968 5 3 2 0.734006748096 6 2 2 0.734008832133 7 4 3 0.748377570273 8 4 4 0.748378530879 9 4 5 0.748379060654 10 3 3 0.748380825401 11 3 4 0.748381786006 12 3 5 0.748382315781 13 2 3 0.748382909438 14 2 4 0.748383870044 15 2 5 0.748384399819 16 4 6 0.759503505815 17 4 7 0.759505004517 18 3 6 0.759506760942 19 3 7 0.759508259645 20 2 6 0.759508844980 21 2 7 0.759510343682 22 4 8 0.812793475685 23 4 9 0.812794770138 24 4 10 0.812795758736 25 3 8 0.812796730812 26 3 9 0.812798025266 27 2 8 0.812798814850 28 3 10 0.812799013863 29 2 9 0.812800109303 30 2 10 0.812801097901 31 4 11 0.843358614153 32 4 12 0.843360322435 33 3 11 0.843361869281 34 4 13 0.843363558213 35 3 12 0.843363577562 36 2 11 0.843363953318 37 2 12 0.843365661600 38 3 13 0.843366813340 39 2 13 0.843368897377 40 4 14 0.852063709983 41 3 14 0.852066965111 42 2 14 0.852069049148 43 4 15 0.856086393009 44 3 15 0.856089648136 45 2 15 0.856091732174 46 1 1 1.197679433274 47 1 2 1.292600990831 48 1 3 1.306975068136 49 1 4 1.306976028742 50 1 5 1.306976558517 51 1 6 1.318101003677 52 1 7 1.318102502380 53 1 8 1.371390973548 54 1 9 1.371392268001 55 1 10 1.371393256599 56 1 11 1.401956112016 57 1 12 1.401957820298 58 1 13 1.401961056075 59 1 14 1.410661207846 60 1 15 1.414683890871 Finished calculating the cv couples. Finished initiating. Precondition is used in the algorithm, ============================== Davidson iteration: 1 num of basis: 40 40 Transition energy 1 : 0.6429970174 40 Transition energy 2 : 0.6432073473 40 Transition energy 3 : 0.6432141524 40 Transition energy 4 : 0.7394583775 40 Transition energy 5 : 0.7398316141 40 Transition energy 6 : 0.7398374492 40 Transition energy 7 : 0.7462525794 40 Transition energy 8 : 0.7463020903 40 Transition energy 9 : 0.7463042429 40 Transition energy 10 : 0.7463644595 40 Transition energy 11 : 0.7463672087 40 Transition energy 12 : 0.7478599888 40 Transition energy 13 : 0.7478612570 40 Transition energy 14 : 0.7478622779 40 Transition energy 15 : 0.7574935743 40 Transition energy 16 : 0.7574950254 40 Transition energy 17 : 0.7574970208 40 Transition energy 18 : 0.7579104010 40 Transition energy 19 : 0.7579111983 40 Transition energy 20 : 0.7579143978 residue: 1 0.0094378 0.0000010 residue: 2 0.0101563 0.0000010 residue: 3 0.0101630 0.0000010 residue: 4 0.0099361 0.0000003 residue: 5 0.0111562 0.0000004 residue: 6 0.0111685 0.0000004 residue: 7 0.0058497 0.0000006 residue: 8 0.0062239 0.0000005 residue: 9 0.0062212 0.0000006 residue: 10 0.0013967 0.0000007 residue: 11 0.0014041 0.0000004 residue: 12 0.0000235 0.0000007 residue: 13 0.0000234 0.0000006 residue: 14 0.0000232 0.0000004 residue: 15 0.0015703 0.0000004 residue: 16 0.0015713 0.0000005 residue: 17 0.0015724 0.0000006 residue: 18 0.0002072 0.0000005 residue: 19 0.0002070 0.0000005 residue: 20 0.0002074 0.0000004 Largest residue: 0.011168519918 ============================== Davidson iteration: 2 num of basis: 57 57 Transition energy 1 : 0.6414411830 57 Transition energy 2 : 0.6414834920 57 Transition energy 3 : 0.6414857900 57 Transition energy 4 : 0.7378028362 57 Transition energy 5 : 0.7378942277 57 Transition energy 6 : 0.7378964865 57 Transition energy 7 : 0.7454193432 57 Transition energy 8 : 0.7454292535 57 Transition energy 9 : 0.7454308240 57 Transition energy 10 : 0.7460801192 57 Transition energy 11 : 0.7460815730 57 Transition energy 12 : 0.7478547465 57 Transition energy 13 : 0.7478560411 57 Transition energy 14 : 0.7478569526 57 Transition energy 15 : 0.7570793174 57 Transition energy 16 : 0.7570801572 57 Transition energy 17 : 0.7570820155 57 Transition energy 18 : 0.7578526128 57 Transition energy 19 : 0.7578532471 57 Transition energy 20 : 0.7578557798 residue: 1 0.0007496 0.0003268 residue: 2 0.0008468 0.0005043 residue: 3 0.0008484 0.0005053 residue: 4 0.0008810 0.0004923 residue: 5 0.0010226 0.0008065 residue: 6 0.0010235 0.0008075 residue: 7 0.0001354 0.0003199 residue: 8 0.0001394 0.0003527 residue: 9 0.0001397 0.0003523 residue: 10 0.0000562 0.0001963 residue: 11 0.0000566 0.0001978 residue: 12 0.0000102 0.0000028 residue: 13 0.0000101 0.0000026 residue: 14 0.0000098 0.0000026 residue: 15 0.0000773 0.0000769 residue: 16 0.0000762 0.0000769 residue: 17 0.0000753 0.0000769 residue: 18 0.0000080 0.0000251 residue: 19 0.0000080 0.0000251 residue: 20 0.0000081 0.0000260 Largest residue: 0.001023529978 ============================== Davidson iteration: 3 num of basis: 77 77 Transition energy 1 : 0.6413285844 77 Transition energy 2 : 0.6413344957 77 Transition energy 3 : 0.6413366869 77 Transition energy 4 : 0.7376581641 77 Transition energy 5 : 0.7376664139 77 Transition energy 6 : 0.7376686602 77 Transition energy 7 : 0.7453634981 77 Transition energy 8 : 0.7453654928 77 Transition energy 9 : 0.7453670753 77 Transition energy 10 : 0.7460564424 77 Transition energy 11 : 0.7460576487 77 Transition energy 12 : 0.7478547278 77 Transition energy 13 : 0.7478559895 77 Transition energy 14 : 0.7478569196 77 Transition energy 15 : 0.7570710927 77 Transition energy 16 : 0.7570725920 77 Transition energy 17 : 0.7570749252 77 Transition energy 18 : 0.7578525792 77 Transition energy 19 : 0.7578532343 77 Transition energy 20 : 0.7578557548 residue: 1 0.0000524 0.0000697 residue: 2 0.0000603 0.0000891 residue: 3 0.0000610 0.0000895 residue: 4 0.0000632 0.0000951 residue: 5 0.0000860 0.0001110 residue: 6 0.0000866 0.0001117 residue: 7 0.0000430 0.0000268 residue: 8 0.0000489 0.0000292 residue: 9 0.0000492 0.0000285 residue: 10 0.0000566 0.0000092 residue: 11 0.0000567 0.0000094 residue: 12 0.0000102 0.0000028 residue: 13 0.0000102 0.0000027 residue: 14 0.0000099 0.0000026 residue: 15 0.0000558 0.0000685 residue: 16 0.0000602 0.0000686 residue: 17 0.0000556 0.0000705 residue: 18 0.0000080 0.0000250 residue: 19 0.0000080 0.0000251 residue: 20 0.0000081 0.0000259 Largest residue: 0.000111714355 ============================== Davidson iteration: 4 num of basis: 79 79 Transition energy 1 : 0.6413242453 79 Transition energy 2 : 0.6413262899 79 Transition energy 3 : 0.6413285985 79 Transition energy 4 : 0.7376548381 79 Transition energy 5 : 0.7376569255 79 Transition energy 6 : 0.7376581642 79 Transition energy 7 : 0.7453634611 79 Transition energy 8 : 0.7453649897 79 Transition energy 9 : 0.7453665442 79 Transition energy 10 : 0.7460564420 79 Transition energy 11 : 0.7460576470 79 Transition energy 12 : 0.7478547253 79 Transition energy 13 : 0.7478559881 79 Transition energy 14 : 0.7478569167 79 Transition energy 15 : 0.7570696024 79 Transition energy 16 : 0.7570711915 79 Transition energy 17 : 0.7570747897 79 Transition energy 18 : 0.7578525767 79 Transition energy 19 : 0.7578532342 79 Transition energy 20 : 0.7578557534 residue: 1 0.0000464 0.0000103 residue: 2 0.0000469 0.0000105 residue: 3 0.0000524 0.0000694 residue: 4 0.0000710 0.0000199 residue: 5 0.0000715 0.0000203 residue: 6 0.0000632 0.0000951 residue: 7 0.0000429 0.0000265 residue: 8 0.0000454 0.0000254 residue: 9 0.0000455 0.0000246 residue: 10 0.0000566 0.0000092 residue: 11 0.0000568 0.0000094 residue: 12 0.0000102 0.0000028 residue: 13 0.0000102 0.0000027 residue: 14 0.0000099 0.0000026 residue: 15 0.0000497 0.0000714 residue: 16 0.0000534 0.0000709 residue: 17 0.0000557 0.0000709 residue: 18 0.0000080 0.0000250 residue: 19 0.0000080 0.0000251 residue: 20 0.0000081 0.0000259 Largest residue: 0.000095065952 ================================================================ Davidson diagonalization has finished, now print out information of eigen pairs K-S Oscillator strengths occ con R-x R-y R-z 1 1 -0.81243554E-05 0.11278346E-04 -0.20550578E-04 1 2 0.12503549E-05 0.26501826E-05 0.19860345E-04 1 3 -0.30445758E-01 0.35557034E-01 -0.33136217E-01 1 4 -0.46303837E-01 -0.33101264E-01 0.70227321E-02 1 5 0.14771617E-01 -0.30492663E-01 -0.46276657E-01 1 6 -0.65632774E-05 0.42953315E-05 0.30381931E-05 1 7 0.15005026E-05 -0.96645628E-05 0.17730066E-04 1 8 0.31403284E-01 -0.31515382E-02 0.54648690E-01 1 9 0.13014313E-01 -0.60665175E-01 -0.11009266E-01 1 10 -0.53067695E-01 -0.16712097E-01 0.29507966E-01 1 11 0.53112587E-01 -0.42123702E-01 -0.25996690E-01 1 12 -0.25552998E-01 0.91664638E-02 -0.67273932E-01 1 13 -0.42233610E-01 -0.58323460E-01 0.81591499E-02 1 14 0.16875989E-04 0.14260325E-04 -0.27096717E-05 1 15 0.18507658E-04 -0.34375643E-04 -0.81974153E-04 2 1 -0.26030132E+00 0.35611181E+00 0.73180227E-02 2 2 0.21006066E+00 -0.28735613E+00 -0.59516977E-02 2 3 -0.35666831E-01 0.26081875E-01 -0.62137380E-01 2 4 0.70944700E-02 -0.67614907E-02 -0.24372581E-01 2 5 -0.51618336E-01 0.37688591E-01 0.40997282E-01 2 6 0.12178275E+00 0.16595457E+00 0.13864486E-03 2 7 0.69651575E-01 -0.96468201E-01 0.40050219E-02 2 8 -0.40757021E+00 0.29340426E+00 -0.25135091E+00 2 9 0.91580406E-01 -0.62038861E-01 -0.42844024E+00 2 10 -0.21781047E+00 0.16956724E+00 0.30560456E+00 2 11 0.19455005E-02 -0.11040859E-02 -0.55541363E-02 2 12 0.46396876E-02 -0.36656024E-02 0.88540094E-03 2 13 -0.11929026E-02 0.72527362E-03 0.54073292E-04 2 14 0.15391404E+00 -0.21043692E+00 -0.42263678E-02 2 15 0.10608467E+00 -0.57574244E-01 0.46461296E-02 3 1 0.19934394E+00 0.13783342E+00 0.36868195E+00 3 2 -0.16082041E+00 -0.11123358E+00 -0.29747355E+00 3 3 0.26341178E-01 -0.55141688E-01 0.89397777E-02 3 4 -0.34863392E-01 -0.48539244E-01 -0.40226145E-01 3 5 -0.54676163E-01 -0.11552605E-01 -0.12524290E-01 3 6 -0.93214288E-01 0.64396221E-01 0.53089045E-03 3 7 -0.53376396E-01 -0.37439263E-01 0.19865416E+00 3 8 -0.13384742E+00 -0.47084231E+00 -0.77617874E-01 3 9 0.50128673E+00 -0.54454231E-01 0.21594804E+00 3 10 0.43646604E-01 0.28739016E+00 0.22329229E+00 3 11 0.34726222E-02 -0.27295570E-02 -0.42271453E-04 3 12 0.19389596E-02 0.37166508E-02 0.68077450E-03 3 13 0.32498979E-02 0.22654522E-02 0.30691244E-02 3 14 -0.11836038E+00 -0.81176685E-01 -0.21835550E+00 3 15 -0.80159609E-01 -0.21850872E-01 0.20862297E+00 4 1 -0.29519566E+00 -0.22099739E+00 0.24223850E+00 4 2 0.23825054E+00 0.17832148E+00 -0.19550534E+00 4 3 0.49364807E-01 0.74799647E-02 -0.11667004E-01 4 4 -0.29592227E-01 -0.41160188E-01 0.61986408E-01 4 5 0.87158109E-02 0.53302138E-01 0.17798025E-01 4 6 0.13795415E+00 -0.10294464E+00 0.36945328E-03 4 7 0.79001390E-01 0.59810999E-01 0.13062411E+00 4 8 0.26919390E+00 0.17901099E+00 0.12586850E+00 4 9 0.25732261E+00 -0.13415318E+00 -0.31579107E+00 4 10 0.22163827E+00 0.45266041E+00 -0.34959818E+00 4 11 0.85748399E-03 -0.41696934E-02 0.75240944E-04 4 12 -0.31006167E-02 -0.32070367E-02 -0.64769218E-03 4 13 0.30260700E-02 0.19724846E-02 -0.43439975E-02 4 14 0.17522426E+00 0.13035171E+00 -0.14366452E+00 4 15 0.11978100E+00 0.35142895E-01 0.13679520E+00 ! The 1 -th eigen state. The transition energy is: 0.64132425 The two digitals below indicate the importance of doing beyong TDA: Components: X 1.00018; Y -0.00018 In the occ-virt project subspace the total Fxy is: X 0.99908; Y -0.00003 total 0.99905 / 1.00000 The Chi_i_i is Total 1 2 3 0.32038578E-01 0.56630631E-02 0.37925686E-02 0.22582946E-01 Now is the components analysis of this transition. Firt we print out only the principle components. occ virt FX FY 3 1 0.99718 -0.00170 Now for all the calculated particle and hole pairs : occ virt FX FY 1 1 0.14656295E-05 0.20636538E-05 1 2 -0.16909579E-05 -0.21195380E-05 1 3 0.17923107E-02 0.61586179E-03 1 4 0.15711568E-02 0.53812579E-03 1 5 0.27147457E-02 0.92908253E-03 1 6 0.12506071E-05 0.18068120E-05 1 7 -0.24657158E-06 -0.90276516E-07 1 8 0.43882353E-02 0.15802945E-02 1 9 -0.18668977E-02 -0.67222315E-03 1 10 -0.25062614E-03 -0.91862462E-04 1 11 0.60692727E-03 0.23216695E-03 1 12 0.27764299E-02 0.10627121E-02 1 13 0.13524096E-02 0.51629366E-03 1 14 -0.90964848E-06 -0.15920853E-05 1 15 -0.66727439E-05 -0.26987900E-05 2 1 0.43785974E-01 -0.74006238E-04 2 2 0.19946910E-02 0.13285108E-03 2 3 0.13655129E-03 0.10456682E-04 2 4 0.48626145E-04 0.38450572E-05 2 5 -0.60275797E-04 -0.51869737E-05 2 6 0.49047879E-02 0.41368483E-03 2 7 -0.21921814E-04 -0.19501590E-05 2 8 0.43130724E-03 0.50196814E-04 2 9 0.52150232E-03 0.61118888E-04 2 10 -0.34618401E-03 -0.41330716E-04 2 11 -0.14284165E-02 -0.19391435E-03 2 12 0.84839718E-03 0.11606905E-03 2 13 -0.15155533E-04 -0.19874912E-05 2 14 0.97637434E-03 0.13655121E-03 2 15 0.42198231E-03 0.27433920E-04 3 1 0.99718134E+00 -0.17024900E-02 3 2 0.45462699E-01 0.30339307E-02 3 3 -0.13316066E-04 0.90886483E-07 3 4 0.16028272E-03 0.13345869E-04 3 5 0.10708379E-03 0.66183187E-05 3 6 -0.74789960E-03 -0.62927141E-04 3 7 0.59630720E-02 0.50185729E-03 3 8 0.43188934E-03 0.51726923E-04 3 9 -0.58721567E-03 -0.69162680E-04 3 10 -0.45813102E-03 -0.53383189E-04 3 11 0.24545356E-03 0.32676073E-04 3 12 0.70506678E-03 0.95183888E-04 3 13 0.16919215E-02 0.22994647E-03 3 14 0.22038163E-01 0.31607162E-02 3 15 0.20607650E-02 0.14523377E-03 4 1 0.73015910E-02 -0.12480314E-04 4 2 0.33398069E-03 0.22409872E-04 4 3 -0.32527981E-04 -0.25611296E-05 4 4 -0.63405936E-04 -0.51027107E-05 4 5 -0.87627234E-04 -0.66966653E-05 4 6 0.10413153E-02 0.87770951E-04 4 7 0.74078487E-02 0.62504726E-03 4 8 -0.43124356E-03 -0.50577553E-04 4 9 0.31092152E-03 0.36663120E-04 4 10 0.70803039E-04 0.83914806E-05 4 11 -0.35322327E-03 -0.47975095E-04 4 12 -0.86721849E-03 -0.11752218E-03 4 13 -0.69101876E-03 -0.94016412E-04 4 14 0.16384512E-03 0.23294735E-04 4 15 0.27476396E-02 0.17494864E-03 ************** ! The 2 -th eigen state. The transition energy is: 0.64132629 The two digitals below indicate the importance of doing beyong TDA: Components: X 1.00018; Y -0.00018 In the occ-virt project subspace the total Fxy is: X 0.99907; Y -0.00003 total 0.99904 / 1.00000 The Chi_i_i is Total 1 2 3 0.32039188E-01 0.13980023E-01 0.18041860E-01 0.17304931E-04 Now is the components analysis of this transition. Firt we print out only the principle components. occ virt FX FY 2 1 -0.99407 0.00170 Now for all the calculated particle and hole pairs : occ virt FX FY 1 1 0.76363052E-05 0.36403223E-05 1 2 -0.51616645E-05 -0.22681645E-05 1 3 0.29035859E-02 0.99136333E-03 1 4 0.36405613E-03 0.12997469E-03 1 5 -0.21223960E-02 -0.72722872E-03 1 6 -0.16842626E-05 -0.71774261E-06 1 7 0.13931877E-05 0.11738984E-05 1 8 0.16510694E-02 0.59556304E-03 1 9 0.41208570E-02 0.14790705E-02 1 10 -0.17497078E-02 -0.64009682E-03 1 11 -0.29178624E-02 -0.11184290E-02 1 12 0.98309871E-03 0.37324694E-03 1 13 -0.68776331E-03 -0.25631985E-03 1 14 -0.56517948E-05 -0.19793936E-05 1 15 0.73512056E-07 0.37143794E-06 2 1 -0.99406592E+00 0.16972440E-02 2 2 -0.45322183E-01 -0.30248336E-02 2 3 0.13476285E-03 0.93912502E-05 2 4 -0.26815681E-04 -0.25183499E-05 2 5 0.11585348E-03 0.10299545E-04 2 6 -0.19988104E-02 -0.16871074E-03 2 7 0.53618334E-02 0.45363538E-03 2 8 0.75552366E-03 0.87553361E-04 2 9 -0.15178618E-03 -0.18189429E-04 2 10 0.40586889E-03 0.46865689E-04 2 11 0.74050044E-03 0.10110141E-03 2 12 0.17364097E-02 0.23579798E-03 2 13 -0.19119155E-03 -0.25579963E-04 2 14 -0.21970020E-01 -0.31525421E-02 2 15 0.17147746E-02 0.11748853E-03 3 1 0.44221102E-01 -0.76262565E-04 3 2 0.20178495E-02 0.13493672E-03 3 3 -0.15274689E-03 -0.11624630E-04 3 4 -0.45691708E-04 -0.35566189E-05 3 5 0.49633648E-04 0.42376820E-05 3 6 -0.49736379E-02 -0.41948088E-03 3 7 -0.53579466E-03 -0.45216762E-04 3 8 -0.42218183E-03 -0.49042041E-04 3 9 -0.55583628E-03 -0.65180579E-04 3 10 0.29962253E-03 0.35900272E-04 3 11 0.14199614E-02 0.19267259E-03 3 12 -0.83102963E-03 -0.11369776E-03 3 13 0.14863400E-03 0.20171952E-04 3 14 0.97223643E-03 0.14036946E-03 3 15 -0.64368368E-03 -0.76711894E-04 4 1 -0.78855257E-01 0.13455242E-03 4 2 -0.36004643E-02 -0.24013583E-03 4 3 -0.69409242E-04 -0.53049787E-05 4 4 -0.12864273E-05 -0.12239195E-06 4 5 0.75413072E-04 0.62182257E-05 4 6 0.76332739E-02 0.64423135E-03 4 7 0.19415767E-03 0.16446084E-04 4 8 -0.64134392E-04 -0.73168687E-05 4 9 -0.42949962E-03 -0.50488249E-04 4 10 0.26735509E-03 0.31742150E-04 4 11 0.11125596E-02 0.15108151E-03 4 12 -0.71874794E-04 -0.10456154E-04 4 13 0.11592325E-03 0.15697525E-04 4 14 -0.17644022E-02 -0.24871069E-03 4 15 0.74437879E-03 0.50381559E-04 ************** ! The 3 -th eigen state. The transition energy is: 0.64132860 The two digitals below indicate the importance of doing beyong TDA: Components: X 1.00018; Y -0.00018 In the occ-virt project subspace the total Fxy is: X 0.99910; Y -0.00003 total 0.99907 / 1.00000 The Chi_i_i is Total 1 2 3 0.32091944E-01 0.12419075E-01 0.10217344E-01 0.94555254E-02 Now is the components analysis of this transition. Firt we print out only the principle components. occ virt FX FY 4 1 0.99502 -0.00170 Now for all the calculated particle and hole pairs : occ virt FX FY 1 1 0.35068250E-06 0.13423959E-06 1 2 -0.56250494E-07 0.13753649E-06 1 3 0.11757343E-02 0.43270998E-03 1 4 -0.31224391E-02 -0.11641359E-02 1 5 0.10322166E-02 0.39840291E-03 1 6 -0.27478957E-05 -0.26656601E-05 1 7 -0.20090185E-05 0.73325125E-07 1 8 0.87598858E-03 0.34109585E-03 1 9 0.14884214E-02 0.57472210E-03 1 10 0.42709673E-02 0.16746154E-02 1 11 0.97342061E-03 0.42127894E-03 1 12 0.10865298E-02 0.45569647E-03 1 13 -0.26866086E-02 -0.11232793E-02 1 14 0.26581643E-05 0.14242037E-05 1 15 0.63695512E-06 0.86859017E-06 2 1 -0.79097437E-01 0.13558515E-03 2 2 -0.36077415E-02 -0.24090796E-03 2 3 0.67331003E-04 0.49830246E-05 2 4 0.32585729E-04 0.24702993E-05 2 5 -0.86355194E-04 -0.67787801E-05 2 6 -0.76737944E-02 -0.64764653E-03 2 7 0.60060497E-03 0.50824822E-04 2 8 0.73470590E-04 0.82391486E-05 2 9 0.39858016E-03 0.46809546E-04 2 10 -0.32212067E-03 -0.38238424E-04 2 11 -0.11039692E-02 -0.14982327E-03 2 12 0.81940167E-04 0.11820904E-04 2 13 -0.20826243E-05 -0.29182336E-06 2 14 -0.17611947E-02 -0.25077369E-03 2 15 -0.45281008E-03 -0.13155849E-03 3 1 -0.38129221E-02 0.64534082E-05 3 2 -0.17315977E-03 -0.11412421E-04 3 3 -0.50506036E-04 -0.39533012E-05 3 4 -0.68806738E-04 -0.55228518E-05 3 5 -0.84818942E-04 -0.64370722E-05 3 6 0.99880691E-03 0.84210485E-04 3 7 0.73485297E-02 0.62004257E-03 3 8 -0.47892987E-03 -0.56150326E-04 3 9 0.25659970E-03 0.30295221E-04 3 10 0.10754933E-03 0.12778859E-04 3 11 -0.19506973E-03 -0.26479565E-04 3 12 -0.94945309E-03 -0.12883980E-03 3 13 -0.68049983E-03 -0.92575609E-04 3 14 -0.86912194E-04 -0.11734693E-04 3 15 0.25491479E-02 0.61817698E-03 4 1 0.99502175E+00 -0.17048027E-02 4 2 0.45451809E-01 0.30331315E-02 4 3 0.86455583E-04 0.80186088E-05 4 4 -0.17794187E-03 -0.13169488E-04 4 5 0.77845470E-04 0.40674094E-05 4 6 -0.12508155E-02 -0.10554532E-03 4 7 -0.54854143E-03 -0.47951759E-04 4 8 0.30519592E-03 0.36981618E-04 4 9 0.39029650E-03 0.46381314E-04 4 10 0.90664610E-03 0.10659945E-03 4 11 0.50865585E-03 0.67832244E-04 4 12 0.10092044E-02 0.13655840E-03 4 13 -0.19345962E-02 -0.26323426E-03 4 14 0.22377411E-01 0.31522661E-02 4 15 -0.28035392E-03 -0.81589489E-04 ************** ! The 4 -th eigen state. The transition energy is: 0.73765484 The two digitals below indicate the importance of doing beyong TDA: Components: X 1.00016; Y -0.00016 In the occ-virt project subspace the total Fxy is: X 0.99862; Y -0.00003 total 0.99858 / 1.00000 The Chi_i_i is Total 1 2 3 0.19395914E-01 0.41219640E-02 0.17756632E-02 0.13498287E-01 Now is the components analysis of this transition. Firt we print out only the principle components. occ virt FX FY 3 2 0.99307 -0.00245 Now for all the calculated particle and hole pairs : occ virt FX FY 1 1 -0.21831855E-05 -0.20373383E-05 1 2 0.22815551E-05 0.20278084E-05 1 3 -0.28364911E-02 -0.71713105E-03 1 4 -0.23304369E-02 -0.58903535E-03 1 5 -0.37532324E-02 -0.94538220E-03 1 6 -0.13374751E-05 -0.17867888E-05 1 7 -0.56256806E-06 -0.13653870E-06 1 8 -0.62263941E-02 -0.18242117E-02 1 9 0.22704203E-02 0.66539744E-03 1 10 0.51643365E-03 0.15451636E-03 1 11 -0.55555569E-03 -0.16123571E-03 1 12 -0.36338816E-02 -0.10564605E-02 1 13 -0.17023432E-02 -0.49503274E-03 1 14 0.12597819E-05 0.15072566E-05 1 15 0.82533467E-05 0.28855294E-05 2 1 0.58304577E-03 -0.42239104E-04 2 2 -0.13568379E-01 0.33803708E-04 2 3 -0.48561555E-01 -0.35198538E-03 2 4 -0.15381550E-01 -0.11158595E-03 2 5 0.17349769E-01 0.12630389E-03 2 6 -0.88392095E-02 -0.12899212E-03 2 7 -0.52813591E-03 -0.77097336E-05 2 8 -0.90183816E-02 -0.43660111E-03 2 9 -0.97559440E-02 -0.47264300E-03 2 10 0.60095012E-02 0.29204491E-03 2 11 0.29142127E-02 0.19524287E-03 2 12 -0.19911158E-02 -0.13462017E-03 2 13 0.62890507E-04 0.41721503E-05 2 14 0.50451700E-03 0.42495727E-04 2 15 -0.62204304E-03 -0.17579734E-04 3 1 -0.42977525E-01 0.30466764E-02 3 2 0.99307333E+00 -0.24495898E-02 3 3 0.23991297E-02 0.17060179E-04 3 4 -0.51510275E-01 -0.37482730E-03 3 5 -0.31429210E-01 -0.22733796E-03 3 6 0.19093583E-02 0.27787250E-04 3 7 -0.10800349E-01 -0.15691702E-03 3 8 -0.78410417E-02 -0.38078375E-03 3 9 0.11543237E-01 0.55989475E-03 3 10 0.85650806E-02 0.41408319E-03 3 11 -0.69852629E-03 -0.45990792E-04 3 12 -0.14016418E-02 -0.93173196E-04 3 13 -0.36069811E-02 -0.24181359E-03 3 14 -0.37043947E-01 -0.28799472E-02 3 15 -0.23347090E-02 -0.74501730E-04 4 1 0.84483434E-04 -0.59561968E-05 4 2 -0.19562295E-02 0.46962039E-05 4 3 0.12241610E-01 0.88753584E-04 4 4 0.20494594E-01 0.14868292E-03 4 5 0.28136361E-01 0.20379808E-03 4 6 -0.27371817E-02 -0.39893005E-04 4 7 -0.13601042E-01 -0.19869623E-03 4 8 0.82649403E-02 0.40054361E-03 4 9 -0.54046259E-02 -0.26211054E-03 4 10 -0.15297291E-02 -0.74271819E-04 4 11 0.61096287E-03 0.40956578E-04 4 12 0.18584133E-02 0.12434436E-03 4 13 0.14224358E-02 0.95664867E-04 4 14 0.81669069E-04 0.56521310E-05 4 15 -0.32551016E-02 -0.88656410E-04 ************** ! The 5 -th eigen state. The transition energy is: 0.73765693 The two digitals below indicate the importance of doing beyong TDA: Components: X 1.00016; Y -0.00016 In the occ-virt project subspace the total Fxy is: X 0.99860; Y -0.00003 total 0.99857 / 1.00000 The Chi_i_i is Total 1 2 3 0.19397247E-01 0.69034098E-02 0.12464470E-01 0.29366921E-04 Now is the components analysis of this transition. Firt we print out only the principle components. occ virt FX FY 2 2 -0.99289 0.00245 Now for all the calculated particle and hole pairs : occ virt FX FY 1 1 -0.38285772E-05 -0.19640570E-05 1 2 0.16748501E-05 0.67572388E-06 1 3 -0.41566947E-02 -0.10470200E-02 1 4 -0.11587486E-03 -0.31347178E-04 1 5 0.32052917E-02 0.80704398E-03 1 6 0.16774140E-05 0.10997321E-05 1 7 -0.76087626E-06 -0.11588744E-05 1 8 -0.20136955E-02 -0.59197370E-03 1 9 -0.59920831E-02 -0.17523604E-02 1 10 0.20419127E-02 0.60169492E-03 1 11 0.37069064E-02 0.10783642E-02 1 12 -0.11397616E-02 -0.33109822E-03 1 13 0.11939774E-02 0.34443949E-03 1 14 0.33959226E-05 0.62791707E-06 1 15 -0.32361377E-06 -0.68715298E-06 2 1 0.42972020E-01 -0.30461963E-02 2 2 -0.99289055E+00 0.24493775E-02 2 3 -0.31987400E-01 -0.23165122E-03 2 4 0.84048809E-02 0.61901764E-04 2 5 -0.50185996E-01 -0.36394336E-03 2 6 0.50322287E-02 0.73487904E-04 2 7 -0.98868136E-02 -0.14534213E-03 2 8 -0.13688346E-01 -0.66273935E-03 2 9 0.34964513E-02 0.16960388E-03 2 10 -0.80922134E-02 -0.39072303E-03 2 11 -0.16092651E-02 -0.10858406E-03 2 12 -0.35663214E-02 -0.23902776E-03 2 13 0.40751089E-03 0.26475508E-04 2 14 0.37039682E-01 0.28796655E-02 2 15 -0.19279817E-02 -0.54855963E-04 3 1 0.59334410E-03 -0.41180252E-04 3 2 -0.13611243E-01 0.33270085E-04 3 3 0.47928717E-01 0.34723401E-03 3 4 0.15860678E-01 0.11503083E-03 3 5 -0.18165663E-01 -0.13217634E-03 3 6 0.89074221E-02 0.12993919E-03 3 7 0.79491508E-03 0.11574676E-04 3 8 0.87983145E-02 0.42592739E-03 3 9 0.97528395E-02 0.47241103E-03 3 10 -0.62191219E-02 -0.30218747E-03 3 11 -0.29462872E-02 -0.19744901E-03 3 12 0.19328062E-02 0.13076632E-03 3 13 -0.26503885E-04 -0.16817163E-05 3 14 0.52170534E-03 0.39771668E-04 3 15 0.69037243E-03 0.28927455E-04 4 1 0.82494162E-03 -0.57906544E-04 4 2 -0.18978726E-01 0.46690487E-04 4 3 0.19202366E-01 0.13897712E-03 4 4 0.10300428E-01 0.74650971E-04 4 5 -0.30709987E-01 -0.22275948E-03 4 6 -0.13713424E-01 -0.20049484E-03 4 7 0.48787388E-03 0.71444441E-05 4 8 0.36231490E-03 0.17195456E-04 4 9 0.79869400E-02 0.38698917E-03 4 10 -0.63181661E-02 -0.30645971E-03 4 11 -0.24640799E-02 -0.16510939E-03 4 12 -0.98212488E-04 -0.56037520E-05 4 13 -0.74756885E-04 -0.51597344E-05 4 14 0.74103079E-03 0.52826127E-04 4 15 -0.66468343E-03 -0.17621585E-04 ************** ! The 6 -th eigen state. The transition energy is: 0.73765816 The two digitals below indicate the importance of doing beyong TDA: Components: X 1.00017; Y -0.00017 In the occ-virt project subspace the total Fxy is: X 0.99871; Y -0.00003 total 0.99868 / 1.00000 The Chi_i_i is Total 1 2 3 0.19483147E-01 0.84105499E-02 0.51777300E-02 0.58948675E-02 Now is the components analysis of this transition. Firt we print out only the principle components. occ virt FX FY 4 2 0.99292 -0.00245 Now for all the calculated particle and hole pairs : occ virt FX FY 1 1 0.67192697E-06 0.21626836E-06 1 2 -0.81675722E-06 -0.42033478E-06 1 3 -0.13599474E-02 -0.40480290E-03 1 4 0.41703410E-02 0.12491280E-02 1 5 -0.15675224E-02 -0.48107413E-03 1 6 0.16422569E-05 0.26052488E-05 1 7 0.21079479E-05 -0.35849129E-07 1 8 -0.10896951E-02 -0.35861108E-03 1 9 -0.16458084E-02 -0.54113558E-03 1 10 -0.58578669E-02 -0.19295068E-02 1 11 -0.13699250E-02 -0.48139218E-03 1 12 -0.12548793E-02 -0.43398733E-03 1 13 0.31455432E-02 0.10831086E-02 1 14 -0.38398178E-05 -0.16533497E-05 1 15 -0.10994201E-05 -0.77719582E-06 2 1 0.81987709E-03 -0.58645491E-04 2 2 -0.18996660E-01 0.47038278E-04 2 3 -0.19410643E-01 -0.14050602E-03 2 4 -0.11635814E-01 -0.84261376E-04 2 5 0.29743717E-01 0.21580150E-03 2 6 0.13693418E-01 0.20027454E-03 2 7 -0.51050979E-03 -0.75523140E-05 2 8 -0.63883628E-03 -0.30659763E-04 2 9 -0.77685215E-02 -0.37653572E-03 2 10 0.65896963E-02 0.31977011E-03 2 11 0.24364432E-02 0.16330229E-03 2 12 0.39280320E-04 0.17677165E-05 2 13 -0.39718279E-04 -0.28093785E-05 2 14 0.70872106E-03 0.54028417E-04 2 15 0.61096063E-03 0.12372720E-03 3 1 -0.73722646E-04 0.52306571E-05 3 2 0.16951191E-02 -0.43022256E-05 3 3 0.12854024E-01 0.93189415E-04 3 4 0.20663816E-01 0.14993328E-03 3 5 0.28108383E-01 0.20355895E-03 3 6 -0.23545606E-02 -0.34289391E-04 3 7 -0.13544028E-01 -0.19786624E-03 3 8 0.84716548E-02 0.41062534E-03 3 9 -0.53674244E-02 -0.26034636E-03 3 10 -0.15896761E-02 -0.77197671E-04 3 11 0.58641585E-03 0.39333067E-04 3 12 0.18782275E-02 0.12573555E-03 3 13 0.14173252E-02 0.95259202E-04 3 14 -0.56996283E-04 -0.50853417E-05 3 15 -0.29171114E-02 -0.55522684E-03 4 1 -0.43034779E-01 0.30510331E-02 4 2 0.99291708E+00 -0.24538692E-02 4 3 -0.34193499E-01 -0.24838974E-03 4 4 0.60037690E-01 0.43389187E-03 4 5 -0.18896772E-01 -0.13599852E-03 4 6 0.30981997E-02 0.45327819E-04 4 7 0.92134526E-03 0.14768192E-04 4 8 -0.58736708E-02 -0.28557141E-03 4 9 -0.80462817E-02 -0.39041835E-03 4 10 -0.16820719E-01 -0.81568447E-03 4 11 -0.93337697E-03 -0.61120262E-04 4 12 -0.21198240E-02 -0.14174062E-03 4 13 0.40808323E-02 0.27466647E-03 4 14 -0.40099534E-01 -0.28570431E-02 4 15 0.33792456E-03 0.74310603E-04 ************** ! The 7 -th eigen state. The transition energy is: 0.74536346 The two digitals below indicate the importance of doing beyong TDA: Components: X 1.00008; Y -0.00008 In the occ-virt project subspace the total Fxy is: X 0.99917; Y -0.00001 total 0.99916 / 1.00000 The Chi_i_i is Total 1 2 3 0.43374125E-02 0.17546929E-02 0.21620807E-02 0.42063898E-03 Now is the components analysis of this transition. Firt we print out only the principle components. occ virt FX FY 2 3 0.13496 0.00028 2 5 -0.17094 -0.00035 3 3 -0.22396 -0.00046 3 4 -0.39380 -0.00081 3 5 -0.35112 -0.00072 4 3 0.36142 0.00074 4 4 -0.60362 -0.00124 4 5 0.33938 0.00069 Now for all the calculated particle and hole pairs : occ virt FX FY 1 1 0.21521779E-05 0.60831616E-06 1 2 -0.15620703E-05 -0.60746484E-06 1 3 -0.10255987E-02 -0.27982514E-03 1 4 0.35102146E-02 0.97049363E-03 1 5 -0.85346233E-04 -0.40851301E-04 1 6 0.10282934E-05 0.44107434E-06 1 7 0.80178559E-06 -0.49801283E-06 1 8 -0.17770782E-04 -0.18363763E-04 1 9 0.17863183E-02 0.61126460E-03 1 10 0.32149487E-02 0.10774335E-02 1 11 -0.60044354E-03 -0.20857662E-03 1 12 -0.55772824E-03 -0.18862610E-03 1 13 0.36767099E-02 0.11931677E-02 1 14 -0.17729573E-05 -0.81734155E-06 1 15 -0.21118897E-06 -0.58549157E-06 2 1 0.78657812E-03 -0.59722133E-04 2 2 -0.16928434E-01 0.12989060E-03 2 3 0.13495601E+00 0.27652675E-03 2 4 0.64835405E-01 0.13260967E-03 2 5 -0.17094190E+00 -0.35051198E-03 2 6 -0.17922518E-01 -0.16916266E-03 2 7 0.23165663E-02 0.22075208E-04 2 8 0.49190520E-03 0.21948971E-04 2 9 0.26946402E-02 0.11721282E-03 2 10 -0.20990426E-02 -0.91373458E-04 2 11 -0.82874453E-04 -0.10744906E-04 2 12 0.71940248E-05 0.10637131E-05 2 13 0.15971988E-03 0.11508227E-04 2 14 0.20846185E-02 0.14705085E-03 2 15 -0.77914352E-04 -0.11300998E-04 3 1 0.10228542E-02 -0.77638737E-04 3 2 -0.22098690E-01 0.16943281E-03 3 3 -0.22396131E+00 -0.45900647E-03 3 4 -0.39380293E+00 -0.80698258E-03 3 5 -0.35112475E+00 -0.71934480E-03 3 6 0.13210428E-02 0.12102019E-04 3 7 0.11230857E-01 0.10595113E-03 3 8 -0.71982472E-02 -0.31392392E-03 3 9 0.38797836E-02 0.16918189E-03 3 10 0.29496270E-02 0.12880467E-03 3 11 -0.47950174E-04 -0.38365519E-05 3 12 -0.13296673E-03 -0.18240423E-04 3 13 -0.15385537E-03 -0.18746265E-04 3 14 0.25385500E-02 0.18108652E-03 3 15 0.63711646E-03 0.92719424E-04 4 1 -0.39022180E-02 0.29800509E-03 4 2 0.84668978E-01 -0.64946867E-03 4 3 0.36141546E+00 0.74047270E-03 4 4 -0.60362250E+00 -0.12359975E-02 4 5 0.33937664E+00 0.69484637E-03 4 6 -0.14547824E-02 -0.13422048E-04 4 7 -0.47694350E-02 -0.44646061E-04 4 8 0.47242267E-02 0.20574551E-03 4 9 0.30400840E-02 0.13309102E-03 4 10 0.10409000E-01 0.45187325E-03 4 11 0.97776369E-04 0.12649911E-04 4 12 0.16826220E-03 0.21265911E-04 4 13 -0.17698203E-03 -0.25601418E-04 4 14 -0.11080278E-01 -0.73761319E-03 4 15 -0.27763736E-03 -0.64634554E-04 ************** ! The 8 -th eigen state. The transition energy is: 0.74536499 The two digitals below indicate the importance of doing beyong TDA: Components: X 1.00008; Y -0.00008 In the occ-virt project subspace the total Fxy is: X 0.99916; Y -0.00001 total 0.99915 / 1.00000 The Chi_i_i is Total 1 2 3 0.43281470E-02 0.35161285E-03 0.15040335E-02 0.24725007E-02 Now is the components analysis of this transition. Firt we print out only the principle components. occ virt FX FY 2 3 -0.19285 -0.00040 2 4 -0.21916 -0.00045 2 5 0.60846 0.00125 3 3 -0.29867 -0.00061 3 4 -0.44089 -0.00090 4 3 -0.16613 -0.00034 4 4 0.27868 0.00057 4 5 0.38210 0.00078 Now for all the calculated particle and hole pairs : occ virt FX FY 1 1 0.34996318E-06 0.87007672E-07 1 2 -0.72282839E-06 -0.33145498E-06 1 3 -0.32359670E-03 -0.79451607E-04 1 4 0.11974137E-03 0.22795083E-04 1 5 0.37884775E-02 0.10065143E-02 1 6 -0.30618962E-06 0.44259111E-06 1 7 -0.35382778E-05 -0.15044833E-05 1 8 -0.17256471E-02 -0.60410215E-03 1 9 0.26825292E-02 0.94507856E-03 1 10 -0.15945090E-02 -0.54240095E-03 1 11 0.31716958E-02 0.10021105E-02 1 12 0.20242767E-02 0.64353813E-03 1 13 0.90022482E-03 0.27352661E-03 1 14 -0.31799059E-06 -0.33165917E-06 1 15 0.56687608E-06 0.31892876E-06 2 1 0.26831115E-02 -0.20629890E-03 2 2 -0.58542419E-01 0.44927758E-03 2 3 -0.19285008E+00 -0.39554998E-03 2 4 -0.21916073E+00 -0.44914499E-03 2 5 0.60846169E+00 0.12464920E-02 2 6 -0.58607063E-02 -0.54787890E-04 2 7 0.68066059E-02 0.63868746E-04 2 8 0.18100546E-02 0.78397014E-04 2 9 -0.71381706E-02 -0.31048047E-03 2 10 0.72089074E-02 0.31318704E-03 2 11 0.18662780E-03 0.26484208E-04 2 12 0.10456406E-03 0.11037070E-04 2 13 -0.55935810E-04 -0.48085438E-05 2 14 0.67552068E-02 0.48230989E-03 2 15 0.18085241E-03 0.71178518E-04 3 1 0.28182583E-02 -0.21562390E-03 3 2 -0.61228900E-01 0.46969566E-03 3 3 -0.29866595E+00 -0.61182329E-03 3 4 -0.44089242E+00 -0.90271315E-03 3 5 -0.66161770E-02 -0.14073927E-04 3 6 -0.59810653E-02 -0.56253327E-04 3 7 -0.13236668E-01 -0.12454999E-03 3 8 -0.54758240E-02 -0.23889599E-03 3 9 -0.22157976E-03 -0.88344579E-05 3 10 0.59445762E-02 0.25905515E-03 3 11 0.13424575E-03 0.15350923E-04 3 12 -0.11192627E-03 -0.14384287E-04 3 13 -0.17425468E-03 -0.19618464E-04 3 14 0.69861070E-02 0.49843603E-03 3 15 -0.72591420E-03 -0.18306315E-03 4 1 0.12635890E-02 -0.97303794E-04 4 2 -0.27647104E-01 0.21227751E-03 4 3 -0.16612555E+00 -0.34029317E-03 4 4 0.27868009E+00 0.56986590E-03 4 5 0.38209830E+00 0.78171719E-03 4 6 0.91798733E-02 0.86360103E-04 4 7 -0.10249681E-01 -0.96439470E-04 4 8 0.22526083E-02 0.98105398E-04 4 9 -0.71241640E-02 -0.31030933E-03 4 10 -0.10913574E-02 -0.47757488E-04 4 11 0.10743997E-03 0.13660034E-04 4 12 0.80476929E-04 0.78965392E-05 4 13 0.26178982E-03 0.26555907E-04 4 14 0.37530211E-02 0.25028477E-03 4 15 -0.39157603E-03 -0.11709576E-03 ************** ! The 9 -th eigen state. The transition energy is: 0.74536654 The two digitals below indicate the importance of doing beyong TDA: Components: X 1.00008; Y -0.00008 In the occ-virt project subspace the total Fxy is: X 0.99916; Y -0.00001 total 0.99915 / 1.00000 The Chi_i_i is Total 1 2 3 0.43295530E-02 0.22261050E-02 0.66568299E-03 0.14377650E-02 Now is the components analysis of this transition. Firt we print out only the principle components. occ virt FX FY 2 3 -0.64330 -0.00132 2 5 -0.25418 -0.00052 3 3 0.41101 0.00084 3 4 -0.26145 -0.00054 3 5 -0.37481 -0.00077 4 3 0.23187 0.00047 4 4 0.27488 0.00056 Now for all the calculated particle and hole pairs : occ virt FX FY 1 1 -0.27173369E-05 0.17004819E-06 1 2 0.21893287E-05 0.96285794E-07 1 3 0.36575615E-02 0.96702200E-03 1 4 0.10857812E-02 0.28031251E-03 1 5 0.27463306E-03 0.72954349E-04 1 6 0.11415554E-05 0.51217207E-06 1 7 -0.24513454E-05 -0.17473162E-06 1 8 -0.31175533E-02 -0.10880781E-02 1 9 -0.15159092E-02 -0.52950721E-03 1 10 0.81205801E-03 0.28558014E-03 1 11 -0.21195138E-02 -0.66566334E-03 1 12 0.32451497E-02 0.10210026E-02 1 13 0.14950446E-03 0.42795950E-04 1 14 0.16149804E-05 0.30142474E-06 1 15 -0.94023842E-06 0.16363862E-06 2 1 -0.30057262E-02 0.22907892E-03 2 2 0.65087752E-01 -0.49901045E-03 2 3 -0.64330081E+00 -0.13184440E-02 2 4 -0.57088707E-01 -0.11707566E-03 2 5 -0.25417663E+00 -0.52035377E-03 2 6 -0.20173541E-02 -0.19822869E-04 2 7 -0.83212602E-02 -0.78149270E-04 2 8 -0.10101760E-01 -0.44112916E-03 2 9 -0.28849134E-02 -0.12594583E-03 2 10 -0.85076125E-03 -0.36606764E-04 2 11 0.42102046E-04 0.68944184E-05 2 12 -0.21665534E-03 -0.29491730E-04 2 13 0.62151376E-04 0.58729549E-05 2 14 -0.74405527E-02 -0.53346472E-03 2 15 -0.54289811E-03 -0.13234714E-03 3 1 0.28206445E-02 -0.21452476E-03 3 2 -0.60887514E-01 0.46704437E-03 3 3 0.41101389E+00 0.84161747E-03 3 4 -0.26144769E+00 -0.53517373E-03 3 5 -0.37481455E+00 -0.76730488E-03 3 6 0.84552340E-02 0.79589145E-04 3 7 -0.83769294E-02 -0.78870161E-04 3 8 0.79040922E-03 0.35200477E-04 3 9 0.92552554E-02 0.40290432E-03 3 10 0.85658621E-03 0.37541449E-04 3 11 -0.17050713E-03 -0.21607023E-04 3 12 0.66962291E-04 0.66846842E-05 3 13 -0.11844007E-03 -0.17317409E-04 3 14 0.70587985E-02 0.50469541E-03 3 15 -0.39792997E-03 -0.90844317E-04 4 1 0.14078429E-03 -0.10248517E-04 4 2 -0.29380008E-02 0.22323508E-04 4 3 0.23186927E+00 0.47454792E-03 4 4 0.27488232E+00 0.56233115E-03 4 5 -0.39227717E-01 -0.79888303E-04 4 6 -0.12859564E-01 -0.12077011E-03 4 7 -0.99920881E-02 -0.94225097E-04 4 8 0.35331672E-02 0.15413577E-03 4 9 0.10086710E-02 0.43545821E-04 4 10 -0.40172008E-02 -0.17479316E-03 4 11 -0.12229741E-03 -0.13717696E-04 4 12 0.10889362E-03 0.11628762E-04 4 13 -0.57824544E-04 0.18736621E-06 4 14 0.28789697E-03 0.18827971E-04 4 15 -0.77563294E-03 -0.20024553E-03 ************** ! The 10 -th eigen state. The transition energy is: 0.74605644 The two digitals below indicate the importance of doing beyong TDA: Components: X 1.00003; Y -0.00003 In the occ-virt project subspace the total Fxy is: X 0.99942; Y -0.00001 total 0.99941 / 1.00000 The Chi_i_i is Total 1 2 3 0.92113142E-08 0.46141888E-09 0.54995201E-10 0.86949001E-08 Now is the components analysis of this transition. Firt we print out only the principle components. occ virt FX FY 2 3 0.27293 0.00043 2 4 0.23470 0.00037 2 5 -0.14384 -0.00023 3 3 0.24408 0.00039 3 4 -0.33080 -0.00052 3 5 0.56587 0.00090 4 3 0.42413 0.00067 4 4 0.32677 0.00052 4 5 0.26638 0.00042 Now for all the calculated particle and hole pairs : occ virt FX FY 1 1 0.51399831E-06 0.76262206E-07 1 2 -0.45109148E-06 -0.11180572E-06 1 3 -0.15161896E-04 -0.12747929E-05 1 4 -0.73512692E-05 -0.18844369E-05 1 5 0.77842191E-05 0.26789075E-05 1 6 -0.84843333E-03 -0.24226915E-03 1 7 -0.22577470E-02 -0.64478113E-03 1 8 0.59624938E-05 -0.74052154E-06 1 9 -0.24743446E-05 0.23079994E-06 1 10 0.32107212E-06 -0.40274713E-06 1 11 0.75431593E-05 0.12227394E-05 1 12 -0.57780627E-05 -0.49589902E-06 1 13 -0.41807213E-06 -0.41519847E-06 1 14 -0.24136745E-06 -0.61116524E-07 1 15 -0.21184470E-02 -0.67282869E-03 2 1 0.76849742E-05 -0.48630759E-06 2 2 -0.37205900E-04 0.22666175E-06 2 3 0.27293400E+00 0.43338903E-03 2 4 0.23469896E+00 0.37268288E-03 2 5 -0.14384276E+00 -0.22842005E-03 2 6 0.24867585E-04 0.32882886E-07 2 7 0.66451265E-05 0.11269825E-06 2 8 -0.82932137E-02 -0.35363108E-03 2 9 -0.73806869E-02 -0.31554046E-03 2 10 0.11421210E-01 0.48837236E-03 2 11 -0.81345335E-02 -0.50603806E-03 2 12 0.38228877E-02 0.23731259E-03 2 13 0.31602846E-02 0.19653853E-03 2 14 -0.36654504E-04 -0.57598666E-05 2 15 0.15375944E-03 0.75811733E-05 3 1 -0.12892211E-04 0.57965575E-06 3 2 0.13747347E-03 -0.11373508E-05 3 3 0.24408200E+00 0.38737971E-03 3 4 -0.33080426E+00 -0.52480563E-03 3 5 0.56587183E+00 0.89755647E-03 3 6 -0.86755320E-04 -0.81283230E-07 3 7 0.76422174E-04 0.28401547E-06 3 8 -0.17048152E-01 -0.72830885E-03 3 9 0.52998331E-02 0.22763545E-03 3 10 -0.22632559E-01 -0.96703881E-03 3 11 0.10195240E-01 0.63477632E-03 3 12 0.12289633E-01 0.76384195E-03 3 13 -0.67480190E-02 -0.42024137E-03 3 14 -0.70184420E-04 -0.34610604E-05 3 15 0.85788596E-05 0.26676631E-05 4 1 -0.66621015E-06 -0.53874233E-07 4 2 0.15918376E-04 -0.31330692E-06 4 3 0.42413168E+00 0.67211280E-03 4 4 0.32676869E+00 0.51767244E-03 4 5 0.26637807E+00 0.42210696E-03 4 6 -0.26195416E-04 -0.25136934E-06 4 7 0.32939106E-04 0.82944792E-08 4 8 -0.23497307E-01 -0.10031264E-02 4 9 0.21425183E-02 0.91624530E-04 4 10 0.72504787E-02 0.30990635E-03 4 11 -0.29410567E-02 -0.18308398E-03 4 12 0.13083984E-01 0.81376849E-03 4 13 0.62177218E-02 0.38621791E-03 4 14 -0.16856588E-04 -0.12937740E-05 4 15 0.14971715E-04 0.32239192E-05 ************** ! The 11 -th eigen state. The transition energy is: 0.74605765 The two digitals below indicate the importance of doing beyong TDA: Components: X 1.00003; Y -0.00003 In the occ-virt project subspace the total Fxy is: X 0.99941; Y -0.00001 total 0.99941 / 1.00000 The Chi_i_i is Total 1 2 3 0.50630851E-08 0.29078952E-09 0.31862096E-08 0.15860860E-08 Now is the components analysis of this transition. Firt we print out only the principle components. occ virt FX FY 2 3 -0.24203 -0.00038 2 4 0.62151 0.00099 2 5 0.26315 0.00042 3 3 -0.41839 -0.00066 4 3 0.34451 0.00055 4 5 -0.42950 -0.00068 Now for all the calculated particle and hole pairs : occ virt FX FY 1 1 -0.13419700E-05 -0.40260372E-06 1 2 0.10950631E-05 0.38037711E-06 1 3 0.69843833E-05 0.39685737E-05 1 4 -0.23757398E-04 -0.59624301E-05 1 5 -0.88335960E-05 -0.63267332E-06 1 6 -0.22597975E-02 -0.64526234E-03 1 7 0.84926970E-03 0.24261313E-03 1 8 -0.51559396E-05 -0.32524724E-05 1 9 0.53365931E-05 0.39041937E-06 1 10 -0.44712116E-05 -0.15989384E-05 1 11 -0.15704198E-05 -0.32692970E-06 1 12 0.25803194E-05 0.24238114E-05 1 13 -0.13266001E-04 -0.33364504E-05 1 14 -0.50490850E-05 -0.14429966E-05 1 15 0.23699230E-03 0.75236407E-04 2 1 -0.42140989E-05 -0.13661176E-06 2 2 -0.89154126E-04 0.57153502E-06 2 3 -0.24202884E+00 -0.38407877E-03 2 4 0.62150888E+00 0.98673847E-03 2 5 0.26314907E+00 0.41685564E-03 2 6 -0.40452584E-04 -0.65973313E-06 2 7 0.43203357E-04 0.14527733E-06 2 8 -0.47773149E-02 -0.20408994E-03 2 9 0.23110191E-01 0.98729993E-03 2 10 0.17832136E-01 0.76132052E-03 2 11 0.37239580E-02 0.23169150E-03 2 12 0.53207933E-03 0.33492826E-04 2 13 0.17310097E-01 0.10761665E-02 2 14 0.41386789E-04 0.32607005E-05 2 15 -0.19430206E-04 -0.16524101E-05 3 1 -0.27546047E-05 0.40933224E-06 3 2 -0.28818328E-04 0.41847182E-07 3 3 -0.41839181E+00 -0.66312306E-03 3 4 -0.15948783E-01 -0.24924607E-04 3 5 0.20650363E-02 0.30538929E-05 3 6 -0.15099154E-04 0.96287633E-07 3 7 -0.69655506E-05 -0.19769665E-07 3 8 0.13844704E-01 0.59078203E-03 3 9 0.10247158E-01 0.43812552E-03 3 10 -0.82219378E-03 -0.35378871E-04 3 11 0.57537829E-02 0.35826898E-03 3 12 -0.82869134E-02 -0.51547317E-03 3 13 0.21723532E-02 0.13423265E-03 3 14 -0.77644602E-04 -0.28659732E-05 3 15 0.21099149E-04 0.50392507E-06 4 1 0.11128325E-04 -0.50251315E-06 4 2 -0.26879685E-04 0.19224283E-06 4 3 0.34451073E+00 0.54559947E-03 4 4 0.67362679E-01 0.10688285E-03 4 5 -0.42950019E+00 -0.67966461E-03 4 6 0.42146460E-04 0.37211049E-06 4 7 -0.35086844E-04 -0.40464386E-06 4 8 -0.24119563E-02 -0.10264491E-03 4 9 -0.20065405E-01 -0.85816729E-03 4 10 0.10661663E-01 0.45627063E-03 4 11 -0.13454790E-01 -0.83748812E-03 4 12 0.69393959E-03 0.42952142E-04 4 13 -0.26733537E-02 -0.16735628E-03 4 14 -0.92413498E-04 -0.67009960E-05 4 15 -0.95914458E-05 0.36409196E-05 ************** ! The 12 -th eigen state. The transition energy is: 0.74785473 The two digitals below indicate the importance of doing beyong TDA: Components: X 1.00000; Y -0.00000 In the occ-virt project subspace the total Fxy is: X 0.99999; Y -0.00000 total 0.99999 / 1.00000 The Chi_i_i is Total 1 2 3 0.11546982E-08 0.28904220E-09 0.59010626E-09 0.27554974E-09 Now is the components analysis of this transition. Firt we print out only the principle components. occ virt FX FY 2 4 -0.18933 -0.00007 3 3 0.14688 0.00006 3 4 -0.61068 -0.00023 3 5 0.26615 0.00010 4 3 -0.20879 -0.00008 4 4 -0.29824 -0.00011 4 5 -0.60302 -0.00023 Now for all the calculated particle and hole pairs : occ virt FX FY 1 1 0.10943984E-05 0.36985082E-06 1 2 -0.96183302E-06 -0.31616463E-06 1 3 0.16914553E-04 0.14185129E-06 1 4 -0.51605398E-05 -0.29190936E-05 1 5 0.82770959E-05 -0.14255175E-05 1 6 -0.90163117E-05 0.11387952E-06 1 7 -0.42363063E-05 -0.71327027E-06 1 8 0.10418903E-05 0.74693386E-06 1 9 0.23136435E-05 0.80348413E-06 1 10 -0.15784006E-05 -0.15839159E-05 1 11 0.20620032E-05 0.11586567E-06 1 12 0.14773748E-04 -0.21548689E-06 1 13 -0.19342783E-05 -0.16467729E-05 1 14 -0.17861631E-05 -0.53273584E-06 1 15 -0.40586279E-05 -0.49666503E-06 2 1 -0.91928232E-06 0.30953652E-07 2 2 0.17495587E-05 0.43404999E-07 2 3 0.25715950E-01 0.98881883E-05 2 4 -0.18933370E+00 -0.72561656E-04 2 5 0.30708114E-01 0.11756112E-04 2 6 -0.14466237E-01 -0.11204355E-03 2 7 -0.52985655E-02 -0.41020356E-04 2 8 0.15213113E-03 0.62219250E-05 2 9 -0.82739219E-03 -0.33967140E-04 2 10 -0.22660801E-02 -0.93750262E-04 2 11 -0.18829454E-03 -0.96674749E-05 2 12 -0.49627645E-04 -0.24966341E-05 2 13 0.44467112E-03 0.22368929E-04 2 14 0.12452348E-04 0.20010422E-05 2 15 -0.41319632E-04 -0.92164366E-05 3 1 -0.28771366E-05 -0.20009569E-07 3 2 -0.21698400E-05 0.19432336E-06 3 3 0.14687758E+00 0.56248222E-04 3 4 -0.61067638E+00 -0.23320067E-03 3 5 0.26614744E+00 0.10148116E-03 3 6 -0.51765032E-02 -0.39686256E-04 3 7 -0.13254309E-01 -0.10267873E-03 3 8 -0.12354340E-02 -0.51180103E-04 3 9 -0.15892114E-02 -0.64796826E-04 3 10 -0.82944215E-02 -0.34318774E-03 3 11 -0.82484850E-03 -0.41838772E-04 3 12 -0.54484177E-03 -0.27686488E-04 3 13 0.14866945E-02 0.75392471E-04 3 14 0.21033540E-04 0.56609127E-06 3 15 -0.48274617E-04 -0.12712172E-04 4 1 0.84005239E-05 -0.29785598E-07 4 2 0.17939150E-05 0.10398992E-06 4 3 -0.20878611E+00 -0.79368910E-04 4 4 -0.29823560E+00 -0.11315700E-03 4 5 -0.60302033E+00 -0.22845204E-03 4 6 -0.48057649E-02 -0.37637237E-04 4 7 0.20324892E-01 0.15774598E-03 4 8 0.71810257E-02 0.29634790E-03 4 9 -0.51150301E-02 -0.21158012E-03 4 10 0.49992485E-04 0.26064581E-05 4 11 0.71932509E-03 0.36754786E-04 4 12 0.14618718E-02 0.74511948E-04 4 13 0.91266880E-03 0.46601988E-04 4 14 -0.24396480E-05 0.11963496E-06 4 15 0.97578322E-04 0.23627925E-04 ************** ! The 13 -th eigen state. The transition energy is: 0.74785599 The two digitals below indicate the importance of doing beyong TDA: Components: X 1.00000; Y -0.00000 In the occ-virt project subspace the total Fxy is: X 0.99999; Y -0.00000 total 0.99999 / 1.00000 The Chi_i_i is Total 1 2 3 0.90316342E-09 0.48373589E-09 0.34662229E-09 0.72805235E-10 Now is the components analysis of this transition. Firt we print out only the principle components. occ virt FX FY 2 3 0.18331 0.00007 2 4 -0.61400 -0.00023 2 5 0.23433 0.00009 3 4 0.16855 0.00006 4 3 0.64622 0.00024 4 5 -0.26841 -0.00010 Now for all the calculated particle and hole pairs : occ virt FX FY 1 1 -0.44391040E-06 -0.19082374E-06 1 2 0.36625323E-06 0.15675787E-06 1 3 -0.23012817E-04 0.11171331E-06 1 4 -0.25442249E-05 0.44091065E-05 1 5 0.72542565E-05 -0.85426920E-06 1 6 -0.10929853E-05 0.88003579E-06 1 7 0.92268136E-06 -0.24610962E-06 1 8 -0.51947039E-05 0.14017574E-06 1 9 0.18881468E-05 0.91541822E-06 1 10 -0.13815322E-04 0.20320447E-05 1 11 0.13477743E-04 -0.82902494E-06 1 12 -0.89599290E-05 -0.25466259E-06 1 13 -0.10836485E-06 0.17031704E-05 1 14 -0.18351825E-05 -0.47951420E-06 1 15 -0.10404158E-05 -0.42139318E-06 2 1 -0.17403834E-05 0.27568998E-07 2 2 -0.92755410E-05 0.26062190E-06 2 3 0.18331057E+00 0.70252548E-04 2 4 -0.61399995E+00 -0.23482799E-03 2 5 0.23433423E+00 0.89491140E-04 2 6 0.33352092E-02 0.26258884E-04 2 7 0.14737739E-01 0.11419964E-03 2 8 -0.13383832E-02 -0.55371722E-04 2 9 -0.21578179E-02 -0.88338705E-04 2 10 -0.81721523E-02 -0.33815670E-03 2 11 -0.70300981E-03 -0.35556835E-04 2 12 -0.59258431E-03 -0.30293342E-04 2 13 0.15152615E-02 0.76673526E-04 2 14 0.46943412E-04 -0.29440872E-06 2 15 0.59220516E-04 0.14811585E-04 3 1 0.13585384E-05 -0.87318539E-07 3 2 -0.81171877E-05 0.29798003E-07 3 3 -0.55069070E-01 -0.21020491E-04 3 4 0.16854890E+00 0.64239929E-04 3 5 -0.62862011E-01 -0.23947320E-04 3 6 -0.15934711E-01 -0.12357002E-03 3 7 0.96135288E-03 0.74582116E-05 3 8 0.37390340E-03 0.15443817E-04 3 9 0.62863996E-03 0.25773569E-04 3 10 0.22398108E-02 0.92664779E-04 3 11 0.16673829E-03 0.82664741E-05 3 12 0.18230454E-03 0.94252178E-05 3 13 -0.43853174E-03 -0.22328678E-04 3 14 -0.55126933E-05 0.13563051E-05 3 15 -0.47123768E-05 -0.22303632E-05 4 1 0.16547927E-04 -0.20640071E-06 4 2 -0.47123205E-04 0.24298164E-06 4 3 0.64621523E+00 0.24484236E-03 4 4 0.91709910E-01 0.34696940E-04 4 5 -0.26841207E+00 -0.10142358E-03 4 6 -0.19743073E-01 -0.15291956E-03 4 7 -0.18202172E-02 -0.14115386E-04 4 8 -0.49247244E-02 -0.20257885E-03 4 9 -0.68053986E-02 -0.28158595E-03 4 10 0.26352825E-02 0.10899207E-03 4 11 0.15782965E-02 0.80300291E-04 4 12 -0.98786638E-03 -0.50118830E-04 4 13 0.35153070E-03 0.17945314E-04 4 14 0.14252976E-04 0.98764725E-06 4 15 -0.16800066E-04 -0.91265993E-05 ************** ! The 14 -th eigen state. The transition energy is: 0.74785692 The two digitals below indicate the importance of doing beyong TDA: Components: X 1.00000; Y -0.00000 In the occ-virt project subspace the total Fxy is: X 0.99999; Y -0.00000 total 0.99999 / 1.00000 The Chi_i_i is Total 1 2 3 0.50873226E-09 0.32632188E-09 0.18241034E-09 0.46123891E-16 Now is the components analysis of this transition. Firt we print out only the principle components. occ virt FX FY 2 3 0.37799 0.00014 2 4 0.29649 0.00011 2 5 0.51676 0.00020 3 3 0.57890 0.00022 3 5 -0.40336 -0.00015 Now for all the calculated particle and hole pairs : occ virt FX FY 1 1 0.26163258E-06 0.32640501E-07 1 2 -0.21098297E-06 -0.27916911E-07 1 3 -0.70496727E-05 -0.19590438E-06 1 4 -0.39322964E-05 -0.14604818E-05 1 5 -0.12959815E-04 -0.31170375E-05 1 6 0.14702256E-05 -0.13110890E-06 1 7 -0.48886121E-05 -0.34653728E-06 1 8 0.46342330E-05 0.70295077E-06 1 9 0.60806975E-05 -0.87205389E-06 1 10 0.68589030E-05 0.67231136E-06 1 11 -0.33015252E-05 -0.95220424E-06 1 12 -0.74818253E-05 -0.12479235E-05 1 13 0.19833832E-06 -0.63144349E-06 1 14 0.12572544E-05 0.37054790E-06 1 15 -0.54649645E-05 -0.85945872E-06 2 1 -0.30539766E-05 -0.39226719E-07 2 2 -0.30852062E-04 0.14642627E-06 2 3 0.37798683E+00 0.14437619E-03 2 4 0.29648544E+00 0.11309538E-03 2 5 0.51676288E+00 0.19682828E-03 2 6 -0.52963124E-03 -0.37001019E-05 2 7 0.20315332E-01 0.15707959E-03 2 8 -0.82578549E-02 -0.34062429E-03 2 9 0.31177148E-02 0.12894418E-03 2 10 0.41187308E-03 0.16438357E-04 2 11 -0.29191868E-03 -0.14972730E-04 2 12 -0.16722950E-02 -0.85024665E-04 2 13 -0.74746402E-03 -0.38145421E-04 2 14 0.79237275E-05 0.21047295E-06 2 15 0.92987919E-04 0.21264755E-04 3 1 0.15564927E-04 -0.29524475E-07 3 2 -0.10328334E-04 -0.61860975E-07 3 3 0.57890235E+00 0.22022861E-03 3 4 -0.31454704E-01 -0.11999973E-04 3 5 -0.40336454E+00 -0.15301855E-03 3 6 0.19970868E-01 0.15463336E-03 3 7 -0.47501400E-02 -0.36761881E-04 3 8 -0.29416524E-02 -0.12075525E-03 3 9 -0.81059187E-02 -0.33536769E-03 3 10 0.19885642E-02 0.82433795E-04 3 11 0.16452939E-02 0.83661905E-04 3 12 -0.58831179E-03 -0.29729904E-04 3 13 0.65453373E-03 0.33093672E-04 3 14 0.39520860E-04 0.78504165E-06 3 15 0.25052833E-04 0.11488100E-05 4 1 0.19607375E-05 -0.93571969E-07 4 2 -0.54990579E-05 0.53257980E-07 4 3 -0.96439103E-02 -0.36442567E-05 4 4 -0.19483220E-01 -0.73528882E-05 4 5 -0.42851264E-01 -0.16181354E-04 4 6 -0.18621540E-02 -0.14441526E-04 4 7 0.64249230E-02 0.49777892E-04 4 8 0.42082392E-03 0.17358451E-04 4 9 -0.38962150E-03 -0.16100564E-04 4 10 0.53052408E-05 0.25442790E-06 4 11 0.54535509E-04 0.27491616E-05 4 12 0.10746287E-03 0.55921185E-05 4 13 0.74035975E-04 0.38509652E-05 4 14 0.14831314E-04 0.97796746E-06 4 15 0.84106648E-04 0.11743619E-04 ************** ! The 15 -th eigen state. The transition energy is: 0.75706960 The two digitals below indicate the importance of doing beyong TDA: Components: X 1.00004; Y -0.00004 In the occ-virt project subspace the total Fxy is: X 0.99956; Y -0.00001 total 0.99956 / 1.00000 The Chi_i_i is Total 1 2 3 0.53716447E-02 0.26622608E-02 0.28201941E-03 0.24273645E-02 Now is the components analysis of this transition. Firt we print out only the principle components. occ virt FX FY 2 6 0.19932 0.00032 2 7 0.30885 0.00050 3 6 -0.33447 -0.00054 3 7 0.43812 0.00071 4 6 0.50923 0.00083 4 7 0.54584 0.00089 Now for all the calculated particle and hole pairs : occ virt FX FY 1 1 0.50852405E-05 -0.36816399E-05 1 2 -0.33819034E-05 0.24192411E-05 1 3 -0.23150812E-02 -0.59580973E-03 1 4 -0.91983125E-03 -0.22638366E-03 1 5 -0.61800452E-03 -0.16330761E-03 1 6 -0.69866867E-05 -0.32680690E-05 1 7 -0.30213040E-05 -0.96739701E-06 1 8 -0.12749031E-02 -0.64122745E-03 1 9 -0.33824962E-03 -0.16822155E-03 1 10 0.29605154E-03 0.14737448E-03 1 11 0.86741741E-03 0.25311912E-03 1 12 -0.19225033E-02 -0.56718230E-03 1 13 -0.32832168E-03 -0.91973775E-04 1 14 -0.19022231E-05 0.12683953E-05 1 15 -0.25912917E-05 -0.12365471E-05 2 1 0.71171348E-02 -0.60074226E-03 2 2 -0.11106231E-01 0.17124271E-03 2 3 -0.16301783E-01 0.93682576E-04 2 4 -0.22478213E-02 0.12722444E-04 2 5 -0.36885481E-02 0.20831860E-04 2 6 0.19932288E+00 0.32476690E-03 2 7 0.30884615E+00 0.50315351E-03 2 8 0.29743194E-01 0.10564087E-02 2 9 0.11892135E-01 0.42243213E-03 2 10 -0.71104761E-03 -0.25982646E-04 2 11 -0.48478387E-04 -0.20639646E-05 2 12 0.64250085E-04 0.27559886E-05 2 13 -0.21056454E-05 0.68621617E-07 2 14 -0.28346136E-02 -0.24214738E-04 2 15 0.27719147E-02 0.27210221E-03 3 1 -0.97741768E-02 0.82463152E-03 3 2 0.15243666E-01 -0.23519700E-03 3 3 0.83543359E-02 -0.48117748E-04 3 4 -0.87644550E-02 0.50655436E-04 3 5 -0.96505023E-02 0.55211443E-04 3 6 -0.33446675E+00 -0.54429611E-03 3 7 0.43812052E+00 0.71303954E-03 3 8 0.21735868E-02 0.77401463E-04 3 9 -0.29025826E-01 -0.10308298E-02 3 10 -0.65864672E-02 -0.23344590E-03 3 11 0.37094344E-04 0.15838586E-05 3 12 -0.58326637E-04 -0.41050124E-05 3 13 0.36043820E-05 -0.20764478E-06 3 14 0.38813490E-02 0.26674015E-04 3 15 0.26965383E-02 0.28311382E-03 4 1 -0.15811645E-03 0.12831259E-04 4 2 0.24116187E-03 -0.36194368E-05 4 3 0.56845009E-02 -0.32751676E-04 4 4 0.64208025E-02 -0.37395199E-04 4 5 0.14153167E-02 -0.80171063E-05 4 6 0.50923013E+00 0.82799970E-03 4 7 0.54583637E+00 0.88715518E-03 4 8 -0.13205023E-01 -0.46873476E-03 4 9 0.32434953E-04 0.14607284E-05 4 10 0.10376726E-01 0.36847972E-03 4 11 0.49577411E-05 0.29661156E-06 4 12 -0.47765390E-04 -0.28216565E-05 4 13 0.43117947E-04 0.25058603E-05 4 14 0.10286805E-03 0.59464326E-05 4 15 0.51803614E-02 0.51722521E-03 ************** ! The 16 -th eigen state. The transition energy is: 0.75707119 The two digitals below indicate the importance of doing beyong TDA: Components: X 1.00004; Y -0.00004 In the occ-virt project subspace the total Fxy is: X 0.99955; Y -0.00001 total 0.99954 / 1.00000 The Chi_i_i is Total 1 2 3 0.53698822E-02 0.74109486E-03 0.25426003E-02 0.20861870E-02 Now is the components analysis of this transition. Firt we print out only the principle components. occ virt FX FY 2 6 -0.28881 -0.00047 2 7 0.37558 0.00061 3 6 -0.33198 -0.00054 3 7 -0.49433 -0.00080 4 6 0.51303 0.00083 4 7 -0.39232 -0.00064 Now for all the calculated particle and hole pairs : occ virt FX FY 1 1 0.20182995E-05 -0.70368741E-06 1 2 -0.12676727E-05 -0.38129489E-07 1 3 -0.69262362E-03 -0.16302325E-03 1 4 0.41010142E-04 0.40903464E-05 1 5 0.25230830E-02 0.64806526E-03 1 6 0.18640721E-05 0.20054129E-05 1 7 -0.11280371E-05 -0.18668398E-05 1 8 0.42941954E-03 0.21116039E-03 1 9 -0.11302123E-02 -0.56701587E-03 1 10 0.59022151E-03 0.28325554E-03 1 11 0.19410442E-02 0.56690489E-03 1 12 0.77301835E-03 0.23250564E-03 1 13 0.56304310E-03 0.16229004E-03 1 14 0.77102806E-06 -0.27833870E-07 1 15 -0.14464618E-05 -0.12599270E-05 2 1 0.94889530E-02 -0.80146833E-03 2 2 -0.14808766E-01 0.22860145E-03 2 3 0.15788257E-02 -0.90999438E-05 2 4 0.49090633E-02 -0.28383629E-04 2 5 -0.15547806E-01 0.89038760E-04 2 6 -0.28880835E+00 -0.47003825E-03 2 7 0.37558246E+00 0.61154932E-03 2 8 0.11218257E-01 0.39864428E-03 2 9 -0.19631362E-01 -0.69717420E-03 2 10 0.22183113E-01 0.78789661E-03 2 11 0.85691063E-05 -0.58370679E-06 2 12 -0.10899640E-04 -0.18464125E-05 2 13 -0.96957938E-05 -0.12686538E-06 2 14 -0.39081835E-02 -0.25253215E-04 2 15 0.23301440E-02 0.22995972E-03 3 1 0.68726508E-02 -0.58010906E-03 3 2 -0.10719791E-01 0.16550640E-03 3 3 0.94249961E-02 -0.54045183E-04 3 4 0.10120008E-01 -0.58049873E-04 3 5 -0.87450888E-03 0.51841489E-05 3 6 -0.33198256E+00 -0.54001951E-03 3 7 -0.49432795E+00 -0.80400607E-03 3 8 -0.18355774E-01 -0.65199350E-03 3 9 -0.50622581E-02 -0.17976164E-03 3 10 0.18285061E-01 0.64980055E-03 3 11 0.32163015E-04 0.92651296E-06 3 12 -0.80258698E-04 -0.40869996E-05 3 13 -0.50403378E-04 -0.25467165E-05 3 14 -0.28857322E-02 -0.11544631E-04 3 15 -0.43977236E-02 -0.45441330E-03 4 1 0.29733791E-02 -0.25101772E-03 4 2 -0.46132158E-02 0.71271249E-04 4 3 0.46078305E-02 -0.26231965E-04 4 4 -0.48529627E-02 0.27892070E-04 4 5 -0.97692768E-02 0.56792832E-04 4 6 0.51303340E+00 0.83345969E-03 4 7 -0.39232269E+00 -0.63724800E-03 4 8 0.57694018E-02 0.20532403E-03 4 9 -0.21901506E-01 -0.77813204E-03 4 10 0.59304733E-03 0.21122254E-04 4 11 0.26619625E-04 0.82818861E-06 4 12 -0.14078090E-04 -0.12249010E-05 4 13 0.10743057E-03 0.56450013E-05 4 14 -0.10599676E-02 -0.62388396E-04 4 15 -0.20843675E-02 -0.20274272E-03 ************** ! The 17 -th eigen state. The transition energy is: 0.75707479 The two digitals below indicate the importance of doing beyong TDA: Components: X 1.00004; Y -0.00004 In the occ-virt project subspace the total Fxy is: X 0.99956; Y -0.00001 total 0.99955 / 1.00000 The Chi_i_i is Total 1 2 3 0.53801790E-02 0.19718500E-02 0.25508203E-02 0.85750872E-03 Now is the components analysis of this transition. Firt we print out only the principle components. occ virt FX FY 2 6 0.78810 0.00128 2 7 -0.10860 -0.00018 3 7 -0.57742 -0.00094 4 7 0.15620 0.00025 Now for all the calculated particle and hole pairs : occ virt FX FY 1 1 -0.26104446E-05 -0.22297908E-07 1 2 0.20968946E-05 0.27031205E-06 1 3 0.86407643E-03 0.22641267E-03 1 4 -0.23974243E-02 -0.63428230E-03 1 5 0.29969036E-03 0.88354272E-04 1 6 -0.90510059E-05 -0.35172407E-05 1 7 0.15130583E-05 0.10578507E-05 1 8 0.12995800E-03 0.57403965E-04 1 9 0.67109660E-03 0.31885576E-03 1 10 0.13158065E-02 0.59299327E-03 1 11 0.42323078E-03 0.12592653E-03 1 12 0.54015654E-03 0.15759371E-03 1 13 -0.20761648E-02 -0.60580700E-03 1 14 0.30573615E-05 0.98636295E-06 1 15 0.14032610E-05 0.10085831E-05 2 1 -0.23197869E-02 0.19559060E-03 2 2 0.36220139E-02 -0.55843349E-04 2 3 0.48343156E-02 -0.27493041E-04 2 4 0.20666431E-02 -0.12006842E-04 2 5 -0.48607061E-02 0.28526343E-04 2 6 0.78810247E+00 0.12813881E-02 2 7 -0.10860181E+00 -0.17668056E-03 2 8 -0.31644772E-02 -0.11199064E-03 2 9 -0.10501397E-01 -0.37308356E-03 2 10 0.78663277E-02 0.27939722E-03 2 11 0.26220760E-04 0.97400905E-06 2 12 -0.23709927E-04 -0.16074273E-05 2 13 -0.72551822E-05 -0.10237365E-05 2 14 0.91678149E-03 0.37036768E-05 2 15 0.51995925E-03 0.78645566E-04 3 1 -0.18690645E-02 0.15805982E-03 3 2 0.29210636E-02 -0.45122076E-04 3 3 -0.57605307E-02 0.33272744E-04 3 4 -0.85357382E-02 0.49483819E-04 3 5 -0.80891790E-02 0.46579797E-04 3 6 -0.52021999E-01 -0.84667576E-04 3 7 -0.57742455E+00 -0.93779332E-03 3 8 0.21384956E-01 0.75958545E-03 3 9 -0.10295606E-01 -0.36610852E-03 3 10 -0.77438347E-02 -0.27503883E-03 3 11 0.15778914E-04 0.59688310E-06 3 12 0.28243900E-04 0.11200832E-05 3 13 0.46399976E-04 0.22239752E-05 3 14 0.77473430E-03 0.41078041E-05 3 15 -0.38141712E-02 -0.51264864E-03 4 1 0.11691114E-01 -0.98664997E-03 4 2 -0.18161439E-01 0.28030327E-03 4 3 0.87230593E-02 -0.50332010E-04 4 4 -0.15517853E-01 0.89175891E-04 4 5 0.76733620E-02 -0.43893029E-04 4 6 0.52579729E-01 0.85387493E-04 4 7 0.15620138E+00 0.25363476E-03 4 8 -0.13486578E-01 -0.47914093E-03 4 9 -0.10890101E-01 -0.38664777E-03 4 10 -0.33470122E-01 -0.11883974E-02 4 11 0.83784292E-05 0.12096068E-05 4 12 -0.48701643E-05 0.58470726E-06 4 13 0.13132627E-05 -0.65260732E-06 4 14 -0.44493713E-02 -0.26298993E-03 4 15 0.11589996E-02 0.12935194E-03 ************** ! The 18 -th eigen state. The transition energy is: 0.75785258 The two digitals below indicate the importance of doing beyong TDA: Components: X 1.00001; Y -0.00001 In the occ-virt project subspace the total Fxy is: X 0.99993; Y -0.00000 total 0.99992 / 1.00000 The Chi_i_i is Total 1 2 3 0.35953137E-07 0.10942832E-08 0.23280367E-07 0.11578487E-07 Now is the components analysis of this transition. Firt we print out only the principle components. occ virt FX FY 2 6 -0.42479 -0.00047 2 7 0.15249 0.00017 3 6 -0.13327 -0.00015 3 7 -0.44627 -0.00050 4 6 -0.35187 -0.00039 4 7 0.67366 0.00075 Now for all the calculated particle and hole pairs : occ virt FX FY 1 1 0.31051240E-05 0.92438330E-06 1 2 -0.26628276E-05 -0.78902817E-06 1 3 -0.67641188E-05 0.98781149E-06 1 4 0.92126644E-05 -0.56212562E-05 1 5 0.51552853E-05 -0.19651210E-05 1 6 -0.24608321E-05 0.24107176E-06 1 7 0.63700256E-06 -0.86856709E-06 1 8 -0.39168927E-05 0.23548441E-05 1 9 -0.40202233E-05 -0.27064940E-05 1 10 0.76398754E-05 -0.32672526E-05 1 11 0.54684481E-05 0.46732680E-07 1 12 -0.31090845E-05 0.19702237E-06 1 13 0.65551617E-06 -0.33432946E-05 1 14 -0.60370215E-05 -0.16891798E-05 1 15 -0.83026933E-06 -0.10600936E-05 2 1 0.17107618E-04 -0.15480609E-05 2 2 -0.26535118E-04 0.39626644E-06 2 3 -0.53419502E-02 0.33287313E-04 2 4 0.80529401E-02 -0.50321683E-04 2 5 -0.68200926E-02 0.42299560E-04 2 6 -0.42479465E+00 -0.47232156E-03 2 7 0.15248990E+00 0.16950108E-03 2 8 -0.51160524E-02 -0.17931705E-03 2 9 -0.11622300E-02 -0.40573931E-04 2 10 -0.91091913E-02 -0.31881016E-03 2 11 0.11263681E-02 0.59940950E-04 2 12 0.17317312E-02 0.92363279E-04 2 13 -0.17355248E-02 -0.92071102E-04 2 14 0.80183069E-05 0.70828971E-05 2 15 0.12442415E-04 0.72321174E-05 3 1 0.27453859E-04 -0.21959884E-05 3 2 -0.37589854E-04 0.56847250E-06 3 3 -0.80204815E-02 0.50276629E-04 3 4 0.15882381E-01 -0.99297477E-04 3 5 -0.35238727E-02 0.22031008E-04 3 6 -0.13327220E+00 -0.14794579E-03 3 7 -0.44627416E+00 -0.49553362E-03 3 8 -0.39263327E-02 -0.13761206E-03 3 9 -0.72384815E-02 -0.25347543E-03 3 10 -0.13941046E-01 -0.48781925E-03 3 11 0.75222145E-03 0.39880034E-04 3 12 0.16196816E-02 0.86502222E-04 3 13 -0.37796142E-02 -0.20143867E-03 3 14 -0.12005215E-04 0.39093243E-05 3 15 -0.15893995E-03 -0.43524279E-04 4 1 -0.11567057E-04 0.71792787E-06 4 2 0.70237949E-05 -0.42997248E-07 4 3 0.49476933E-03 -0.33392712E-05 4 4 0.75125473E-02 -0.47187552E-04 4 5 0.19251793E-01 -0.12107752E-03 4 6 -0.35187335E+00 -0.38999345E-03 4 7 0.67366049E+00 0.74654624E-03 4 8 0.11635815E-01 0.40734881E-03 4 9 -0.14518362E-01 -0.50791265E-03 4 10 0.17811857E-02 0.62204639E-04 4 11 -0.29291593E-02 -0.15605485E-03 4 12 -0.29026800E-02 -0.15494713E-03 4 13 -0.24791696E-02 -0.13172888E-03 4 14 0.65192192E-05 0.18843585E-06 4 15 0.17758019E-03 0.66772899E-04 ************** ! The 19 -th eigen state. The transition energy is: 0.75785323 The two digitals below indicate the importance of doing beyong TDA: Components: X 1.00001; Y -0.00001 In the occ-virt project subspace the total Fxy is: X 0.99993; Y -0.00000 total 0.99992 / 1.00000 The Chi_i_i is Total 1 2 3 0.35440833E-07 0.28003079E-07 0.45678421E-08 0.28699122E-08 Now is the components analysis of this transition. Firt we print out only the principle components. occ virt FX FY 2 6 -0.18766 -0.00021 2 7 -0.20807 -0.00023 3 6 0.72638 0.00081 3 7 -0.16459 -0.00018 4 6 0.54976 0.00061 4 7 0.25059 0.00028 Now for all the calculated particle and hole pairs : occ virt FX FY 1 1 0.26902196E-05 0.71080510E-06 1 2 -0.22348499E-05 -0.59258415E-06 1 3 0.10395748E-04 0.12728198E-05 1 4 -0.87285112E-05 -0.41485661E-05 1 5 0.77553781E-05 -0.18241437E-05 1 6 0.46383059E-05 -0.30627249E-06 1 7 -0.17263230E-05 0.41936778E-06 1 8 0.83104935E-05 0.15532565E-06 1 9 0.64449899E-05 -0.91556192E-06 1 10 0.53752698E-05 -0.38479143E-05 1 11 -0.15855586E-06 -0.11583923E-05 1 12 0.71493428E-05 0.39654815E-06 1 13 0.36165411E-05 0.25547652E-07 1 14 0.61472477E-05 0.16673208E-05 1 15 0.18478765E-05 0.89039358E-06 2 1 -0.22027686E-04 0.19899031E-05 2 2 0.34931039E-04 -0.56533780E-06 2 3 0.26555357E-03 -0.17521233E-05 2 4 -0.19227678E-01 0.12052228E-03 2 5 0.16216558E-03 -0.10807593E-05 2 6 -0.18766217E+00 -0.20861225E-03 2 7 -0.20806928E+00 -0.23115805E-03 2 8 -0.44067092E-02 -0.15439725E-03 2 9 0.64981146E-02 0.22734898E-03 2 10 0.15342945E-01 0.53710329E-03 2 11 -0.13140790E-02 -0.70154035E-04 2 12 0.36346735E-03 0.19548358E-04 2 13 0.42409448E-02 0.22609071E-03 2 14 0.15977850E-04 0.20425189E-05 2 15 -0.84002601E-04 -0.23779127E-04 3 1 0.14893558E-04 -0.12116129E-05 3 2 -0.18510451E-04 0.33043461E-06 3 3 -0.89865837E-02 0.56504119E-04 3 4 0.78984146E-02 -0.49646390E-04 3 5 0.20317169E-02 -0.12209576E-04 3 6 0.72638020E+00 0.80633540E-03 3 7 -0.16459319E+00 -0.18278021E-03 3 8 -0.37056073E-02 -0.12950990E-03 3 9 -0.85783249E-02 -0.30043658E-03 3 10 -0.54327672E-02 -0.19035464E-03 3 11 -0.93019227E-03 -0.49464812E-04 3 12 0.12395406E-02 0.66008849E-04 3 13 -0.23545815E-02 -0.12599378E-03 3 14 0.23728880E-04 -0.25472868E-05 3 15 -0.45001288E-04 -0.36808746E-05 4 1 -0.97669698E-05 0.62221516E-06 4 2 0.13287146E-04 -0.14827476E-06 4 3 0.18670198E-01 -0.11681060E-03 4 4 0.39868152E-02 -0.25234423E-04 4 5 -0.38026619E-02 0.24204570E-04 4 6 0.54976036E+00 0.60904497E-03 4 7 0.25058808E+00 0.27759096E-03 4 8 0.12430046E-01 0.43553792E-03 4 9 0.11250943E-01 0.39382014E-03 4 10 -0.51250331E-02 -0.17944277E-03 4 11 0.33352809E-02 0.17809126E-03 4 12 -0.30378115E-02 -0.16222589E-03 4 13 0.39080995E-03 0.20581472E-04 4 14 0.77695088E-05 0.24409435E-06 4 15 0.14518150E-03 0.43867764E-04 ************** ! The 20 -th eigen state. The transition energy is: 0.75785575 The two digitals below indicate the importance of doing beyong TDA: Components: X 1.00001; Y -0.00001 In the occ-virt project subspace the total Fxy is: X 0.99992; Y -0.00000 total 0.99992 / 1.00000 The Chi_i_i is Total 1 2 3 0.12271601E-07 0.91970091E-08 0.30745566E-08 0.35049407E-13 Now is the components analysis of this transition. Firt we print out only the principle components. occ virt FX FY 2 6 0.19181 0.00021 2 7 0.82641 0.00092 3 6 0.47708 0.00053 4 6 -0.21409 -0.00024 Now for all the calculated particle and hole pairs : occ virt FX FY 1 1 -0.16187139E-05 -0.51296695E-06 1 2 0.13807338E-05 0.44743550E-06 1 3 -0.76731759E-05 -0.16680797E-05 1 4 -0.55962782E-05 0.22252164E-05 1 5 -0.50877353E-05 0.61864525E-06 1 6 0.23805685E-05 -0.69122657E-06 1 7 0.16835675E-05 -0.17765397E-06 1 8 -0.28177033E-05 -0.11470616E-05 1 9 -0.93905068E-05 0.54974550E-06 1 10 -0.82797240E-06 0.23627404E-05 1 11 0.16329493E-05 0.83221064E-08 1 12 -0.23833230E-05 0.14410670E-06 1 13 -0.31634352E-05 0.15497275E-05 1 14 0.40737957E-05 0.11717791E-05 1 15 -0.66961204E-05 -0.24519220E-05 2 1 0.12091296E-04 -0.14337129E-05 2 2 -0.24871375E-04 0.35157231E-06 2 3 -0.11440385E-01 0.71551314E-04 2 4 -0.38336139E-02 0.23869172E-04 2 5 -0.15661896E-01 0.97807622E-04 2 6 0.19180702E+00 0.21290410E-03 2 7 0.82640513E+00 0.91680811E-03 2 8 -0.16670975E-01 -0.58364530E-03 2 9 0.48773521E-02 0.17096504E-03 2 10 -0.31398707E-02 -0.11018635E-03 2 11 0.11373973E-02 0.60944631E-04 2 12 0.43472855E-02 0.23132349E-03 2 13 0.83306810E-03 0.44307957E-04 2 14 0.23181047E-04 -0.44345428E-05 2 15 0.31135635E-03 0.90213046E-04 3 1 -0.74683059E-05 0.70685185E-06 3 2 0.13525437E-04 -0.16883105E-06 3 3 -0.13213840E-01 0.82840497E-04 3 4 -0.71969710E-02 0.44907734E-04 3 5 0.13987065E-01 -0.87335402E-04 3 6 0.47708151E+00 0.52875172E-03 3 7 0.25925360E-01 0.28676703E-04 3 8 -0.43044539E-02 -0.15054857E-03 3 9 -0.13741309E-01 -0.48099075E-03 3 10 0.11562084E-01 0.40437443E-03 3 11 -0.46944608E-02 -0.25005861E-03 3 12 0.70647993E-03 0.37547912E-04 3 13 0.22437618E-03 0.11830395E-04 3 14 0.51796735E-04 0.26266829E-05 3 15 0.96269548E-04 0.14667857E-04 4 1 0.67256820E-05 -0.49810984E-06 4 2 -0.99083735E-05 0.87647405E-07 4 3 -0.82046634E-02 0.51393471E-04 4 4 -0.33919739E-02 0.21404301E-04 4 5 -0.25746576E-02 0.15947237E-04 4 6 -0.21408780E+00 -0.23677455E-03 4 7 -0.66384140E-01 -0.73446327E-04 4 8 -0.79383415E-02 -0.27807644E-03 4 9 -0.17455418E-02 -0.61016178E-04 4 10 0.18489249E-02 0.64772468E-04 4 11 -0.79913971E-03 -0.42654732E-04 4 12 0.19379308E-02 0.10330892E-03 4 13 0.35199185E-03 0.18739750E-04 4 14 -0.38550600E-04 -0.22730432E-05 4 15 0.50952527E-06 -0.79202896E-05 ************** Now generate the eigenvalues list... Now generate the spectrum plot file... Finished linear response calculation... lr_solve_e : 4.51s CPU 4.77s WALL ( 1 calls) one_step : 38.69s CPU 49.09s WALL ( 4 calls) lr_apply : 68.02s CPU 77.25s WALL ( 318 calls) lr_apply_int : 51.57s CPU 59.25s WALL ( 159 calls) lr_apply_no : 16.45s CPU 18.00s WALL ( 159 calls) lr_apply : 68.02s CPU 77.25s WALL ( 318 calls) h_psi : 32.59s CPU 34.75s WALL ( 318 calls) lr_calc_dens : 9.62s CPU 11.01s WALL ( 159 calls) lr_ortho : 0.46s CPU 0.51s WALL ( 477 calls) interaction : 8.34s CPU 9.30s WALL ( 159 calls) lr_dot : 2.50s CPU 4.26s WALL ( 21098 calls) US routines lr_sm1_psi : 0.06s CPU 0.11s WALL ( 318 calls) General routines calbec : 0.10s CPU 0.13s WALL ( 426 calls) fft : 13.52s CPU 14.75s WALL ( 321 calls) fftw : 47.16s CPU 49.52s WALL ( 2096 calls) interpolate : 0.22s CPU 0.22s WALL ( 159 calls) davcio : 0.00s CPU 0.01s WALL ( 4 calls) Parallel routines fft_scatter : 5.86s CPU 6.95s WALL ( 2417 calls) EXX routines turboTDDFT : 1m29.78s CPU 2m 0.38s WALL This run was terminated on: 18:49:38 22May2013 =------------------------------------------------------------------------------= JOB DONE. =------------------------------------------------------------------------------= TDDFPT/Examples/CH4-DAV/CH4.pw-in0000644000175000017500000000125212341371500014215 0ustar mbamba&control calculation = 'scf' title = 'TDDFPT CH4 Test (Symmetry Enabled)' restart_mode='from_scratch', pseudo_dir = '../pseudo', outdir='./out', prefix='ch4' etot_conv_thr=1d-6 / &system ibrav = 1, celldm(1) = 20, nat = 5, nbnd = 20 ntyp = 2, ecutwfc = 25, / &electrons / &ions / ATOMIC_SPECIES C 1.0 C.pz-vbc.UPF H 1.0 H.pz-vbc.UPF ATOMIC_POSITIONS {Angstrom} C 0.000000000 0.000000000 0.000000000 H 0.642814093 0.642814093 0.642814093 H -0.642814093 -0.642814093 0.642814093 H 0.642814093 -0.642814093 -0.642814093 H -0.642814093 0.642814093 -0.642814093 K_POINTS {gamma} TDDFPT/Examples/CH4-DAV/ch4.plot-ref0000644000175000017500000207513412341371500015027 0ustar mbamba# Energy(Ry) total X Y Z # Broadening is: 0.0050000 Ry 0.40000000E+00 0.47939565E-02 0.15983890E-02 0.15977089E-02 0.15978586E-02 0.40020000E+00 0.48035808E-02 0.16015978E-02 0.16009165E-02 0.16010665E-02 0.40040000E+00 0.48132291E-02 0.16048147E-02 0.16041320E-02 0.16042824E-02 0.40060000E+00 0.48229013E-02 0.16080395E-02 0.16073556E-02 0.16075063E-02 0.40080000E+00 0.48325977E-02 0.16112724E-02 0.16105871E-02 0.16107382E-02 0.40100000E+00 0.48423183E-02 0.16145134E-02 0.16138267E-02 0.16139781E-02 0.40120000E+00 0.48520631E-02 0.16177624E-02 0.16170745E-02 0.16172262E-02 0.40140000E+00 0.48618322E-02 0.16210196E-02 0.16203303E-02 0.16204824E-02 0.40160000E+00 0.48716258E-02 0.16242849E-02 0.16235942E-02 0.16237467E-02 0.40180000E+00 0.48814439E-02 0.16275583E-02 0.16268664E-02 0.16270191E-02 0.40200000E+00 0.48912865E-02 0.16308400E-02 0.16301467E-02 0.16302998E-02 0.40220000E+00 0.49011538E-02 0.16341299E-02 0.16334352E-02 0.16335887E-02 0.40240000E+00 0.49110458E-02 0.16374280E-02 0.16367320E-02 0.16368858E-02 0.40260000E+00 0.49209627E-02 0.16407344E-02 0.16400371E-02 0.16401912E-02 0.40280000E+00 0.49309044E-02 0.16440491E-02 0.16433504E-02 0.16435049E-02 0.40300000E+00 0.49408712E-02 0.16473722E-02 0.16466721E-02 0.16468269E-02 0.40320000E+00 0.49508630E-02 0.16507036E-02 0.16500021E-02 0.16501573E-02 0.40340000E+00 0.49608799E-02 0.16540433E-02 0.16533405E-02 0.16534961E-02 0.40360000E+00 0.49709221E-02 0.16573915E-02 0.16566873E-02 0.16568433E-02 0.40380000E+00 0.49809896E-02 0.16607481E-02 0.16600426E-02 0.16601989E-02 0.40400000E+00 0.49910825E-02 0.16641132E-02 0.16634063E-02 0.16635630E-02 0.40420000E+00 0.50012009E-02 0.16674868E-02 0.16667785E-02 0.16669355E-02 0.40440000E+00 0.50113448E-02 0.16708689E-02 0.16701592E-02 0.16703166E-02 0.40460000E+00 0.50215144E-02 0.16742596E-02 0.16735485E-02 0.16737062E-02 0.40480000E+00 0.50317097E-02 0.16776588E-02 0.16769464E-02 0.16771045E-02 0.40500000E+00 0.50419308E-02 0.16810667E-02 0.16803528E-02 0.16805113E-02 0.40520000E+00 0.50521778E-02 0.16844832E-02 0.16837679E-02 0.16839267E-02 0.40540000E+00 0.50624508E-02 0.16879083E-02 0.16871917E-02 0.16873508E-02 0.40560000E+00 0.50727499E-02 0.16913422E-02 0.16906241E-02 0.16907836E-02 0.40580000E+00 0.50830751E-02 0.16947847E-02 0.16940652E-02 0.16942252E-02 0.40600000E+00 0.50934266E-02 0.16982360E-02 0.16975151E-02 0.16976754E-02 0.40620000E+00 0.51038044E-02 0.17016961E-02 0.17009738E-02 0.17011345E-02 0.40640000E+00 0.51142086E-02 0.17051650E-02 0.17044413E-02 0.17046023E-02 0.40660000E+00 0.51246394E-02 0.17086428E-02 0.17079176E-02 0.17080790E-02 0.40680000E+00 0.51350967E-02 0.17121294E-02 0.17114028E-02 0.17115646E-02 0.40700000E+00 0.51455808E-02 0.17156249E-02 0.17148969E-02 0.17150590E-02 0.40720000E+00 0.51560916E-02 0.17191293E-02 0.17183999E-02 0.17185624E-02 0.40740000E+00 0.51666292E-02 0.17226427E-02 0.17219118E-02 0.17220747E-02 0.40760000E+00 0.51771938E-02 0.17261651E-02 0.17254328E-02 0.17255960E-02 0.40780000E+00 0.51877855E-02 0.17296964E-02 0.17289627E-02 0.17291263E-02 0.40800000E+00 0.51984043E-02 0.17332369E-02 0.17325017E-02 0.17326657E-02 0.40820000E+00 0.52090503E-02 0.17367864E-02 0.17360498E-02 0.17362142E-02 0.40840000E+00 0.52197236E-02 0.17403450E-02 0.17396069E-02 0.17397717E-02 0.40860000E+00 0.52304244E-02 0.17439128E-02 0.17431732E-02 0.17433384E-02 0.40880000E+00 0.52411526E-02 0.17474897E-02 0.17467487E-02 0.17469142E-02 0.40900000E+00 0.52519084E-02 0.17510758E-02 0.17503334E-02 0.17504993E-02 0.40920000E+00 0.52626919E-02 0.17546712E-02 0.17539272E-02 0.17540936E-02 0.40940000E+00 0.52735032E-02 0.17582758E-02 0.17575304E-02 0.17576971E-02 0.40960000E+00 0.52843424E-02 0.17618897E-02 0.17611428E-02 0.17613099E-02 0.40980000E+00 0.52952095E-02 0.17655129E-02 0.17647646E-02 0.17649320E-02 0.41000000E+00 0.53061047E-02 0.17691455E-02 0.17683957E-02 0.17685635E-02 0.41020000E+00 0.53170280E-02 0.17727875E-02 0.17720362E-02 0.17722044E-02 0.41040000E+00 0.53279796E-02 0.17764388E-02 0.17756861E-02 0.17758547E-02 0.41060000E+00 0.53389595E-02 0.17800997E-02 0.17793454E-02 0.17795144E-02 0.41080000E+00 0.53499679E-02 0.17837700E-02 0.17830142E-02 0.17831837E-02 0.41100000E+00 0.53610048E-02 0.17874498E-02 0.17866926E-02 0.17868624E-02 0.41120000E+00 0.53720703E-02 0.17911392E-02 0.17903804E-02 0.17905507E-02 0.41140000E+00 0.53831646E-02 0.17948382E-02 0.17940779E-02 0.17942485E-02 0.41160000E+00 0.53942877E-02 0.17985467E-02 0.17977849E-02 0.17979560E-02 0.41180000E+00 0.54054397E-02 0.18022650E-02 0.18015016E-02 0.18016731E-02 0.41200000E+00 0.54166207E-02 0.18059928E-02 0.18052280E-02 0.18053998E-02 0.41220000E+00 0.54278309E-02 0.18097304E-02 0.18089641E-02 0.18091363E-02 0.41240000E+00 0.54390702E-02 0.18134778E-02 0.18127099E-02 0.18128825E-02 0.41260000E+00 0.54503389E-02 0.18172349E-02 0.18164655E-02 0.18166385E-02 0.41280000E+00 0.54616370E-02 0.18210018E-02 0.18202309E-02 0.18204043E-02 0.41300000E+00 0.54729647E-02 0.18247786E-02 0.18240061E-02 0.18241800E-02 0.41320000E+00 0.54843219E-02 0.18285652E-02 0.18277912E-02 0.18279655E-02 0.41340000E+00 0.54957089E-02 0.18323618E-02 0.18315862E-02 0.18317609E-02 0.41360000E+00 0.55071257E-02 0.18361683E-02 0.18353912E-02 0.18355663E-02 0.41380000E+00 0.55185725E-02 0.18399848E-02 0.18392061E-02 0.18393816E-02 0.41400000E+00 0.55300492E-02 0.18438113E-02 0.18430310E-02 0.18432069E-02 0.41420000E+00 0.55415561E-02 0.18476478E-02 0.18468660E-02 0.18470423E-02 0.41440000E+00 0.55530933E-02 0.18514944E-02 0.18507111E-02 0.18508878E-02 0.41460000E+00 0.55646607E-02 0.18553511E-02 0.18545662E-02 0.18547434E-02 0.41480000E+00 0.55762586E-02 0.18592180E-02 0.18584315E-02 0.18586091E-02 0.41500000E+00 0.55878871E-02 0.18630951E-02 0.18623070E-02 0.18624850E-02 0.41520000E+00 0.55995462E-02 0.18669824E-02 0.18661927E-02 0.18663711E-02 0.41540000E+00 0.56112361E-02 0.18708799E-02 0.18700887E-02 0.18702675E-02 0.41560000E+00 0.56229569E-02 0.18747877E-02 0.18739949E-02 0.18741742E-02 0.41580000E+00 0.56347086E-02 0.18787059E-02 0.18779115E-02 0.18780912E-02 0.41600000E+00 0.56464914E-02 0.18826344E-02 0.18818384E-02 0.18820185E-02 0.41620000E+00 0.56583054E-02 0.18865733E-02 0.18857758E-02 0.18859563E-02 0.41640000E+00 0.56701507E-02 0.18905227E-02 0.18897235E-02 0.18899045E-02 0.41660000E+00 0.56820274E-02 0.18944825E-02 0.18936817E-02 0.18938631E-02 0.41680000E+00 0.56939356E-02 0.18984529E-02 0.18976504E-02 0.18978323E-02 0.41700000E+00 0.57058754E-02 0.19024337E-02 0.19016297E-02 0.19018120E-02 0.41720000E+00 0.57178470E-02 0.19064252E-02 0.19056195E-02 0.19058022E-02 0.41740000E+00 0.57298504E-02 0.19104273E-02 0.19096200E-02 0.19098031E-02 0.41760000E+00 0.57418857E-02 0.19144400E-02 0.19136311E-02 0.19138146E-02 0.41780000E+00 0.57539532E-02 0.19184634E-02 0.19176529E-02 0.19178369E-02 0.41800000E+00 0.57660528E-02 0.19224976E-02 0.19216854E-02 0.19218698E-02 0.41820000E+00 0.57781846E-02 0.19265425E-02 0.19257287E-02 0.19259135E-02 0.41840000E+00 0.57903489E-02 0.19305982E-02 0.19297827E-02 0.19299680E-02 0.41860000E+00 0.58025458E-02 0.19346647E-02 0.19338476E-02 0.19340334E-02 0.41880000E+00 0.58147752E-02 0.19387422E-02 0.19379234E-02 0.19381096E-02 0.41900000E+00 0.58270374E-02 0.19428305E-02 0.19420101E-02 0.19421968E-02 0.41920000E+00 0.58393324E-02 0.19469298E-02 0.19461078E-02 0.19462948E-02 0.41940000E+00 0.58516605E-02 0.19510401E-02 0.19502164E-02 0.19504039E-02 0.41960000E+00 0.58640216E-02 0.19551615E-02 0.19543361E-02 0.19545240E-02 0.41980000E+00 0.58764159E-02 0.19592939E-02 0.19584668E-02 0.19586552E-02 0.42000000E+00 0.58888435E-02 0.19634374E-02 0.19626086E-02 0.19627975E-02 0.42020000E+00 0.59013046E-02 0.19675921E-02 0.19667616E-02 0.19669510E-02 0.42040000E+00 0.59137993E-02 0.19717579E-02 0.19709258E-02 0.19711156E-02 0.42060000E+00 0.59263276E-02 0.19759350E-02 0.19751012E-02 0.19752914E-02 0.42080000E+00 0.59388897E-02 0.19801233E-02 0.19792878E-02 0.19794785E-02 0.42100000E+00 0.59514857E-02 0.19843230E-02 0.19834858E-02 0.19836770E-02 0.42120000E+00 0.59641158E-02 0.19885340E-02 0.19876951E-02 0.19878867E-02 0.42140000E+00 0.59767800E-02 0.19927564E-02 0.19919158E-02 0.19921079E-02 0.42160000E+00 0.59894785E-02 0.19969902E-02 0.19961479E-02 0.19963404E-02 0.42180000E+00 0.60022114E-02 0.20012355E-02 0.20003914E-02 0.20005845E-02 0.42200000E+00 0.60149789E-02 0.20054923E-02 0.20046465E-02 0.20048400E-02 0.42220000E+00 0.60277809E-02 0.20097607E-02 0.20089131E-02 0.20091071E-02 0.42240000E+00 0.60406178E-02 0.20140406E-02 0.20131914E-02 0.20133858E-02 0.42260000E+00 0.60534895E-02 0.20183322E-02 0.20174812E-02 0.20176761E-02 0.42280000E+00 0.60663962E-02 0.20226355E-02 0.20217827E-02 0.20219781E-02 0.42300000E+00 0.60793381E-02 0.20269504E-02 0.20260959E-02 0.20262918E-02 0.42320000E+00 0.60923153E-02 0.20312771E-02 0.20304209E-02 0.20306172E-02 0.42340000E+00 0.61053278E-02 0.20356157E-02 0.20347577E-02 0.20349545E-02 0.42360000E+00 0.61183759E-02 0.20399660E-02 0.20391063E-02 0.20393036E-02 0.42380000E+00 0.61314596E-02 0.20443283E-02 0.20434668E-02 0.20436645E-02 0.42400000E+00 0.61445791E-02 0.20487025E-02 0.20478392E-02 0.20480374E-02 0.42420000E+00 0.61577345E-02 0.20530886E-02 0.20522236E-02 0.20524223E-02 0.42440000E+00 0.61709259E-02 0.20574868E-02 0.20566200E-02 0.20568192E-02 0.42460000E+00 0.61841535E-02 0.20618970E-02 0.20610284E-02 0.20612281E-02 0.42480000E+00 0.61974173E-02 0.20663193E-02 0.20654489E-02 0.20656491E-02 0.42500000E+00 0.62107176E-02 0.20707538E-02 0.20698816E-02 0.20700822E-02 0.42520000E+00 0.62240545E-02 0.20752004E-02 0.20743264E-02 0.20745276E-02 0.42540000E+00 0.62374280E-02 0.20796593E-02 0.20787835E-02 0.20789852E-02 0.42560000E+00 0.62508383E-02 0.20841305E-02 0.20832529E-02 0.20834550E-02 0.42580000E+00 0.62642856E-02 0.20886139E-02 0.20877345E-02 0.20879372E-02 0.42600000E+00 0.62777700E-02 0.20931098E-02 0.20922286E-02 0.20924317E-02 0.42620000E+00 0.62912916E-02 0.20976180E-02 0.20967350E-02 0.20969386E-02 0.42640000E+00 0.63048505E-02 0.21021387E-02 0.21012538E-02 0.21014580E-02 0.42660000E+00 0.63184470E-02 0.21066719E-02 0.21057852E-02 0.21059898E-02 0.42680000E+00 0.63320810E-02 0.21112176E-02 0.21103291E-02 0.21105342E-02 0.42700000E+00 0.63457528E-02 0.21157760E-02 0.21148856E-02 0.21150912E-02 0.42720000E+00 0.63594625E-02 0.21203469E-02 0.21194547E-02 0.21196609E-02 0.42740000E+00 0.63732103E-02 0.21249306E-02 0.21240365E-02 0.21242432E-02 0.42760000E+00 0.63869962E-02 0.21295270E-02 0.21286311E-02 0.21288382E-02 0.42780000E+00 0.64008205E-02 0.21341361E-02 0.21332383E-02 0.21334460E-02 0.42800000E+00 0.64146832E-02 0.21387581E-02 0.21378585E-02 0.21380666E-02 0.42820000E+00 0.64285844E-02 0.21433929E-02 0.21424914E-02 0.21427001E-02 0.42840000E+00 0.64425245E-02 0.21480407E-02 0.21471373E-02 0.21473465E-02 0.42860000E+00 0.64565034E-02 0.21527014E-02 0.21517961E-02 0.21520058E-02 0.42880000E+00 0.64705213E-02 0.21573751E-02 0.21564680E-02 0.21566782E-02 0.42900000E+00 0.64845784E-02 0.21620619E-02 0.21611529E-02 0.21613636E-02 0.42920000E+00 0.64986748E-02 0.21667618E-02 0.21658509E-02 0.21660621E-02 0.42940000E+00 0.65128106E-02 0.21714748E-02 0.21705620E-02 0.21707738E-02 0.42960000E+00 0.65269860E-02 0.21762010E-02 0.21752863E-02 0.21754986E-02 0.42980000E+00 0.65412012E-02 0.21809405E-02 0.21800239E-02 0.21802368E-02 0.43000000E+00 0.65554563E-02 0.21856933E-02 0.21847748E-02 0.21849882E-02 0.43020000E+00 0.65697514E-02 0.21904595E-02 0.21895390E-02 0.21897529E-02 0.43040000E+00 0.65840866E-02 0.21952390E-02 0.21943166E-02 0.21945310E-02 0.43060000E+00 0.65984623E-02 0.22000320E-02 0.21991077E-02 0.21993226E-02 0.43080000E+00 0.66128784E-02 0.22048384E-02 0.22039122E-02 0.22041277E-02 0.43100000E+00 0.66273351E-02 0.22096585E-02 0.22087303E-02 0.22089463E-02 0.43120000E+00 0.66418326E-02 0.22144921E-02 0.22135620E-02 0.22137785E-02 0.43140000E+00 0.66563710E-02 0.22193394E-02 0.22184073E-02 0.22186244E-02 0.43160000E+00 0.66709505E-02 0.22242003E-02 0.22232663E-02 0.22234839E-02 0.43180000E+00 0.66855713E-02 0.22290750E-02 0.22281390E-02 0.22283572E-02 0.43200000E+00 0.67002334E-02 0.22339635E-02 0.22330256E-02 0.22332443E-02 0.43220000E+00 0.67149371E-02 0.22388659E-02 0.22379260E-02 0.22381453E-02 0.43240000E+00 0.67296825E-02 0.22437822E-02 0.22428403E-02 0.22430601E-02 0.43260000E+00 0.67444698E-02 0.22487124E-02 0.22477685E-02 0.22479889E-02 0.43280000E+00 0.67592990E-02 0.22536566E-02 0.22527107E-02 0.22529317E-02 0.43300000E+00 0.67741704E-02 0.22586149E-02 0.22576670E-02 0.22578885E-02 0.43320000E+00 0.67890842E-02 0.22635873E-02 0.22626374E-02 0.22628595E-02 0.43340000E+00 0.68040404E-02 0.22685738E-02 0.22676220E-02 0.22678446E-02 0.43360000E+00 0.68190393E-02 0.22735746E-02 0.22726207E-02 0.22728439E-02 0.43380000E+00 0.68340809E-02 0.22785897E-02 0.22776338E-02 0.22778575E-02 0.43400000E+00 0.68491656E-02 0.22836190E-02 0.22826611E-02 0.22828854E-02 0.43420000E+00 0.68642933E-02 0.22886628E-02 0.22877029E-02 0.22879277E-02 0.43440000E+00 0.68794644E-02 0.22937210E-02 0.22927590E-02 0.22929844E-02 0.43460000E+00 0.68946789E-02 0.22987936E-02 0.22978296E-02 0.22980556E-02 0.43480000E+00 0.69099370E-02 0.23038809E-02 0.23029148E-02 0.23031414E-02 0.43500000E+00 0.69252389E-02 0.23089827E-02 0.23080146E-02 0.23082417E-02 0.43520000E+00 0.69405847E-02 0.23140991E-02 0.23131290E-02 0.23133567E-02 0.43540000E+00 0.69559747E-02 0.23192303E-02 0.23182581E-02 0.23184863E-02 0.43560000E+00 0.69714089E-02 0.23243762E-02 0.23234019E-02 0.23236308E-02 0.43580000E+00 0.69868876E-02 0.23295369E-02 0.23285606E-02 0.23287900E-02 0.43600000E+00 0.70024109E-02 0.23347126E-02 0.23337341E-02 0.23339642E-02 0.43620000E+00 0.70179789E-02 0.23399031E-02 0.23389226E-02 0.23391532E-02 0.43640000E+00 0.70335919E-02 0.23451086E-02 0.23441261E-02 0.23443572E-02 0.43660000E+00 0.70492501E-02 0.23503292E-02 0.23493445E-02 0.23495763E-02 0.43680000E+00 0.70649535E-02 0.23555649E-02 0.23545781E-02 0.23548105E-02 0.43700000E+00 0.70807024E-02 0.23608157E-02 0.23598269E-02 0.23600598E-02 0.43720000E+00 0.70964969E-02 0.23660818E-02 0.23650908E-02 0.23653243E-02 0.43740000E+00 0.71123373E-02 0.23713631E-02 0.23703700E-02 0.23706042E-02 0.43760000E+00 0.71282236E-02 0.23766598E-02 0.23756646E-02 0.23758993E-02 0.43780000E+00 0.71441561E-02 0.23819718E-02 0.23809745E-02 0.23812098E-02 0.43800000E+00 0.71601350E-02 0.23872994E-02 0.23862999E-02 0.23865358E-02 0.43820000E+00 0.71761604E-02 0.23926424E-02 0.23916407E-02 0.23918773E-02 0.43840000E+00 0.71922324E-02 0.23980010E-02 0.23969972E-02 0.23972343E-02 0.43860000E+00 0.72083514E-02 0.24033752E-02 0.24023692E-02 0.24026070E-02 0.43880000E+00 0.72245174E-02 0.24087651E-02 0.24077570E-02 0.24079953E-02 0.43900000E+00 0.72407306E-02 0.24141707E-02 0.24131605E-02 0.24133994E-02 0.43920000E+00 0.72569913E-02 0.24195922E-02 0.24185798E-02 0.24188193E-02 0.43940000E+00 0.72732996E-02 0.24250295E-02 0.24240149E-02 0.24242551E-02 0.43960000E+00 0.72896556E-02 0.24304828E-02 0.24294660E-02 0.24297068E-02 0.43980000E+00 0.73060597E-02 0.24359521E-02 0.24349331E-02 0.24351745E-02 0.44000000E+00 0.73225118E-02 0.24414374E-02 0.24404162E-02 0.24406583E-02 0.44020000E+00 0.73390124E-02 0.24469388E-02 0.24459154E-02 0.24461581E-02 0.44040000E+00 0.73555614E-02 0.24524564E-02 0.24514308E-02 0.24516741E-02 0.44060000E+00 0.73721592E-02 0.24579903E-02 0.24569625E-02 0.24572064E-02 0.44080000E+00 0.73888059E-02 0.24635404E-02 0.24625104E-02 0.24627550E-02 0.44100000E+00 0.74055017E-02 0.24691070E-02 0.24680747E-02 0.24683199E-02 0.44120000E+00 0.74222467E-02 0.24746899E-02 0.24736555E-02 0.24739013E-02 0.44140000E+00 0.74390413E-02 0.24802894E-02 0.24792527E-02 0.24794992E-02 0.44160000E+00 0.74558855E-02 0.24859054E-02 0.24848665E-02 0.24851136E-02 0.44180000E+00 0.74727796E-02 0.24915381E-02 0.24904969E-02 0.24907446E-02 0.44200000E+00 0.74897237E-02 0.24971874E-02 0.24961440E-02 0.24963923E-02 0.44220000E+00 0.75067181E-02 0.25028535E-02 0.25018078E-02 0.25020568E-02 0.44240000E+00 0.75237630E-02 0.25085364E-02 0.25074885E-02 0.25077381E-02 0.44260000E+00 0.75408585E-02 0.25142362E-02 0.25131860E-02 0.25134363E-02 0.44280000E+00 0.75580049E-02 0.25199530E-02 0.25189005E-02 0.25191514E-02 0.44300000E+00 0.75752023E-02 0.25256868E-02 0.25246320E-02 0.25248836E-02 0.44320000E+00 0.75924509E-02 0.25314376E-02 0.25303805E-02 0.25306328E-02 0.44340000E+00 0.76097511E-02 0.25372057E-02 0.25361462E-02 0.25363992E-02 0.44360000E+00 0.76271028E-02 0.25429909E-02 0.25419292E-02 0.25421828E-02 0.44380000E+00 0.76445064E-02 0.25487934E-02 0.25477294E-02 0.25479836E-02 0.44400000E+00 0.76619621E-02 0.25546133E-02 0.25535470E-02 0.25538019E-02 0.44420000E+00 0.76794701E-02 0.25604506E-02 0.25593819E-02 0.25596375E-02 0.44440000E+00 0.76970305E-02 0.25663054E-02 0.25652344E-02 0.25654907E-02 0.44460000E+00 0.77146436E-02 0.25721778E-02 0.25711044E-02 0.25713614E-02 0.44480000E+00 0.77323096E-02 0.25780678E-02 0.25769921E-02 0.25772497E-02 0.44500000E+00 0.77500287E-02 0.25839755E-02 0.25828975E-02 0.25831557E-02 0.44520000E+00 0.77678011E-02 0.25899010E-02 0.25888206E-02 0.25890795E-02 0.44540000E+00 0.77856270E-02 0.25958443E-02 0.25947615E-02 0.25950212E-02 0.44560000E+00 0.78035067E-02 0.26018056E-02 0.26007204E-02 0.26009807E-02 0.44580000E+00 0.78214403E-02 0.26077848E-02 0.26066973E-02 0.26069582E-02 0.44600000E+00 0.78394281E-02 0.26137821E-02 0.26126922E-02 0.26129538E-02 0.44620000E+00 0.78574702E-02 0.26197975E-02 0.26187052E-02 0.26189675E-02 0.44640000E+00 0.78755670E-02 0.26258311E-02 0.26247364E-02 0.26249994E-02 0.44660000E+00 0.78937185E-02 0.26318830E-02 0.26307859E-02 0.26310496E-02 0.44680000E+00 0.79119251E-02 0.26379533E-02 0.26368537E-02 0.26371181E-02 0.44700000E+00 0.79301870E-02 0.26440419E-02 0.26429399E-02 0.26432051E-02 0.44720000E+00 0.79485043E-02 0.26501491E-02 0.26490447E-02 0.26493105E-02 0.44740000E+00 0.79668773E-02 0.26562748E-02 0.26551680E-02 0.26554345E-02 0.44760000E+00 0.79853063E-02 0.26624192E-02 0.26613099E-02 0.26615771E-02 0.44780000E+00 0.80037913E-02 0.26685823E-02 0.26674705E-02 0.26677385E-02 0.44800000E+00 0.80223328E-02 0.26747642E-02 0.26736500E-02 0.26739186E-02 0.44820000E+00 0.80409309E-02 0.26809649E-02 0.26798483E-02 0.26801176E-02 0.44840000E+00 0.80595857E-02 0.26871846E-02 0.26860655E-02 0.26863356E-02 0.44860000E+00 0.80782977E-02 0.26934234E-02 0.26923017E-02 0.26925726E-02 0.44880000E+00 0.80970669E-02 0.26996812E-02 0.26985571E-02 0.26988286E-02 0.44900000E+00 0.81158937E-02 0.27059582E-02 0.27048316E-02 0.27051039E-02 0.44920000E+00 0.81347782E-02 0.27122545E-02 0.27111254E-02 0.27113983E-02 0.44940000E+00 0.81537206E-02 0.27185701E-02 0.27174384E-02 0.27177121E-02 0.44960000E+00 0.81727214E-02 0.27249051E-02 0.27237709E-02 0.27240454E-02 0.44980000E+00 0.81917805E-02 0.27312596E-02 0.27301229E-02 0.27303981E-02 0.45000000E+00 0.82108984E-02 0.27376336E-02 0.27364944E-02 0.27367703E-02 0.45020000E+00 0.82300752E-02 0.27440273E-02 0.27428856E-02 0.27431622E-02 0.45040000E+00 0.82493111E-02 0.27504408E-02 0.27492965E-02 0.27495739E-02 0.45060000E+00 0.82686065E-02 0.27568740E-02 0.27557272E-02 0.27560053E-02 0.45080000E+00 0.82879616E-02 0.27633272E-02 0.27621778E-02 0.27624566E-02 0.45100000E+00 0.83073765E-02 0.27698003E-02 0.27686483E-02 0.27689279E-02 0.45120000E+00 0.83268516E-02 0.27762934E-02 0.27751389E-02 0.27754193E-02 0.45140000E+00 0.83463871E-02 0.27828067E-02 0.27816496E-02 0.27819307E-02 0.45160000E+00 0.83659832E-02 0.27893403E-02 0.27881805E-02 0.27884624E-02 0.45180000E+00 0.83856402E-02 0.27958941E-02 0.27947318E-02 0.27950144E-02 0.45200000E+00 0.84053584E-02 0.28024683E-02 0.28013034E-02 0.28015868E-02 0.45220000E+00 0.84251380E-02 0.28090630E-02 0.28078954E-02 0.28081796E-02 0.45240000E+00 0.84449791E-02 0.28156782E-02 0.28145080E-02 0.28147930E-02 0.45260000E+00 0.84648822E-02 0.28223140E-02 0.28211413E-02 0.28214270E-02 0.45280000E+00 0.84848475E-02 0.28289706E-02 0.28277952E-02 0.28280817E-02 0.45300000E+00 0.85048751E-02 0.28356480E-02 0.28344699E-02 0.28347572E-02 0.45320000E+00 0.85249655E-02 0.28423463E-02 0.28411656E-02 0.28414536E-02 0.45340000E+00 0.85451187E-02 0.28490656E-02 0.28478822E-02 0.28481710E-02 0.45360000E+00 0.85653352E-02 0.28558059E-02 0.28546198E-02 0.28549094E-02 0.45380000E+00 0.85856151E-02 0.28625674E-02 0.28613787E-02 0.28616690E-02 0.45400000E+00 0.86059587E-02 0.28693501E-02 0.28681587E-02 0.28684499E-02 0.45420000E+00 0.86263663E-02 0.28761542E-02 0.28749601E-02 0.28752520E-02 0.45440000E+00 0.86468381E-02 0.28829797E-02 0.28817829E-02 0.28820756E-02 0.45460000E+00 0.86673745E-02 0.28898267E-02 0.28886271E-02 0.28889207E-02 0.45480000E+00 0.86879756E-02 0.28966952E-02 0.28954930E-02 0.28957874E-02 0.45500000E+00 0.87086418E-02 0.29035855E-02 0.29023806E-02 0.29026757E-02 0.45520000E+00 0.87293733E-02 0.29104976E-02 0.29092899E-02 0.29095858E-02 0.45540000E+00 0.87501704E-02 0.29174315E-02 0.29162211E-02 0.29165178E-02 0.45560000E+00 0.87710334E-02 0.29243874E-02 0.29231742E-02 0.29234718E-02 0.45580000E+00 0.87919625E-02 0.29313653E-02 0.29301494E-02 0.29304478E-02 0.45600000E+00 0.88129581E-02 0.29383654E-02 0.29371467E-02 0.29374459E-02 0.45620000E+00 0.88340203E-02 0.29453878E-02 0.29441663E-02 0.29444663E-02 0.45640000E+00 0.88551496E-02 0.29524324E-02 0.29512082E-02 0.29515090E-02 0.45660000E+00 0.88763461E-02 0.29594995E-02 0.29582725E-02 0.29585741E-02 0.45680000E+00 0.88976102E-02 0.29665891E-02 0.29653593E-02 0.29656618E-02 0.45700000E+00 0.89189421E-02 0.29737014E-02 0.29724687E-02 0.29727720E-02 0.45720000E+00 0.89403421E-02 0.29808363E-02 0.29796008E-02 0.29799050E-02 0.45740000E+00 0.89618105E-02 0.29879941E-02 0.29867557E-02 0.29870607E-02 0.45760000E+00 0.89833477E-02 0.29951747E-02 0.29939336E-02 0.29942394E-02 0.45780000E+00 0.90049538E-02 0.30023784E-02 0.30011344E-02 0.30014411E-02 0.45800000E+00 0.90266292E-02 0.30096051E-02 0.30083583E-02 0.30086658E-02 0.45820000E+00 0.90483742E-02 0.30168551E-02 0.30156054E-02 0.30159138E-02 0.45840000E+00 0.90701891E-02 0.30241283E-02 0.30228758E-02 0.30231850E-02 0.45860000E+00 0.90920742E-02 0.30314250E-02 0.30301695E-02 0.30304796E-02 0.45880000E+00 0.91140297E-02 0.30387451E-02 0.30374868E-02 0.30377978E-02 0.45900000E+00 0.91360560E-02 0.30460889E-02 0.30448276E-02 0.30451395E-02 0.45920000E+00 0.91581534E-02 0.30534563E-02 0.30521922E-02 0.30525049E-02 0.45940000E+00 0.91803221E-02 0.30608476E-02 0.30595805E-02 0.30598941E-02 0.45960000E+00 0.92025625E-02 0.30682627E-02 0.30669927E-02 0.30673071E-02 0.45980000E+00 0.92248750E-02 0.30757018E-02 0.30744289E-02 0.30747442E-02 0.46000000E+00 0.92472597E-02 0.30831651E-02 0.30818892E-02 0.30822054E-02 0.46020000E+00 0.92697170E-02 0.30906525E-02 0.30893737E-02 0.30896908E-02 0.46040000E+00 0.92922473E-02 0.30981643E-02 0.30968825E-02 0.30972005E-02 0.46060000E+00 0.93148508E-02 0.31057005E-02 0.31044157E-02 0.31047346E-02 0.46080000E+00 0.93375278E-02 0.31132612E-02 0.31119735E-02 0.31122932E-02 0.46100000E+00 0.93602788E-02 0.31208465E-02 0.31195558E-02 0.31198764E-02 0.46120000E+00 0.93831039E-02 0.31284566E-02 0.31271629E-02 0.31274844E-02 0.46140000E+00 0.94060035E-02 0.31360915E-02 0.31347948E-02 0.31351172E-02 0.46160000E+00 0.94289779E-02 0.31437513E-02 0.31424516E-02 0.31427750E-02 0.46180000E+00 0.94520275E-02 0.31514363E-02 0.31501335E-02 0.31504578E-02 0.46200000E+00 0.94751526E-02 0.31591463E-02 0.31578406E-02 0.31581657E-02 0.46220000E+00 0.94983535E-02 0.31668817E-02 0.31655729E-02 0.31658989E-02 0.46240000E+00 0.95216306E-02 0.31746424E-02 0.31733306E-02 0.31736576E-02 0.46260000E+00 0.95449841E-02 0.31824287E-02 0.31811137E-02 0.31814417E-02 0.46280000E+00 0.95684144E-02 0.31902405E-02 0.31889225E-02 0.31892514E-02 0.46300000E+00 0.95919218E-02 0.31980781E-02 0.31967570E-02 0.31970868E-02 0.46320000E+00 0.96155068E-02 0.32059415E-02 0.32046173E-02 0.32049480E-02 0.46340000E+00 0.96391695E-02 0.32138308E-02 0.32125035E-02 0.32128352E-02 0.46360000E+00 0.96629104E-02 0.32217462E-02 0.32204158E-02 0.32207484E-02 0.46380000E+00 0.96867298E-02 0.32296878E-02 0.32283543E-02 0.32286878E-02 0.46400000E+00 0.97106280E-02 0.32376556E-02 0.32363190E-02 0.32366534E-02 0.46420000E+00 0.97346055E-02 0.32456499E-02 0.32443101E-02 0.32446455E-02 0.46440000E+00 0.97586624E-02 0.32536706E-02 0.32523277E-02 0.32526641E-02 0.46460000E+00 0.97827993E-02 0.32617180E-02 0.32603720E-02 0.32607093E-02 0.46480000E+00 0.98070164E-02 0.32697922E-02 0.32684429E-02 0.32687812E-02 0.46500000E+00 0.98313141E-02 0.32778932E-02 0.32765408E-02 0.32768800E-02 0.46520000E+00 0.98556927E-02 0.32860212E-02 0.32846656E-02 0.32850058E-02 0.46540000E+00 0.98801526E-02 0.32941764E-02 0.32928175E-02 0.32931587E-02 0.46560000E+00 0.99046942E-02 0.33023587E-02 0.33009967E-02 0.33013388E-02 0.46580000E+00 0.99293179E-02 0.33105684E-02 0.33092032E-02 0.33095463E-02 0.46600000E+00 0.99540239E-02 0.33188056E-02 0.33174371E-02 0.33177812E-02 0.46620000E+00 0.99788127E-02 0.33270703E-02 0.33256986E-02 0.33260437E-02 0.46640000E+00 0.10003685E-01 0.33353628E-02 0.33339878E-02 0.33343339E-02 0.46660000E+00 0.10028640E-01 0.33436831E-02 0.33423049E-02 0.33426520E-02 0.46680000E+00 0.10053679E-01 0.33520314E-02 0.33506499E-02 0.33509980E-02 0.46700000E+00 0.10078803E-01 0.33604078E-02 0.33590230E-02 0.33593721E-02 0.46720000E+00 0.10104011E-01 0.33688123E-02 0.33674243E-02 0.33677744E-02 0.46740000E+00 0.10129304E-01 0.33772453E-02 0.33758539E-02 0.33762050E-02 0.46760000E+00 0.10154683E-01 0.33857066E-02 0.33843119E-02 0.33846641E-02 0.46780000E+00 0.10180147E-01 0.33941966E-02 0.33927986E-02 0.33931517E-02 0.46800000E+00 0.10205697E-01 0.34027153E-02 0.34013139E-02 0.34016681E-02 0.46820000E+00 0.10231334E-01 0.34112628E-02 0.34098581E-02 0.34102133E-02 0.46840000E+00 0.10257058E-01 0.34198394E-02 0.34184313E-02 0.34187875E-02 0.46860000E+00 0.10282869E-01 0.34284450E-02 0.34270336E-02 0.34273908E-02 0.46880000E+00 0.10308768E-01 0.34370799E-02 0.34356651E-02 0.34360233E-02 0.46900000E+00 0.10334755E-01 0.34457441E-02 0.34443259E-02 0.34446852E-02 0.46920000E+00 0.10360831E-01 0.34544379E-02 0.34530163E-02 0.34533766E-02 0.46940000E+00 0.10386995E-01 0.34631613E-02 0.34617363E-02 0.34620977E-02 0.46960000E+00 0.10413249E-01 0.34719144E-02 0.34704860E-02 0.34708485E-02 0.46980000E+00 0.10439592E-01 0.34806975E-02 0.34792657E-02 0.34796292E-02 0.47000000E+00 0.10466026E-01 0.34895106E-02 0.34880753E-02 0.34884399E-02 0.47020000E+00 0.10492550E-01 0.34983540E-02 0.34969152E-02 0.34972808E-02 0.47040000E+00 0.10519165E-01 0.35072276E-02 0.35057854E-02 0.35061521E-02 0.47060000E+00 0.10545871E-01 0.35161317E-02 0.35146860E-02 0.35150537E-02 0.47080000E+00 0.10572670E-01 0.35250664E-02 0.35236172E-02 0.35239860E-02 0.47100000E+00 0.10599560E-01 0.35340318E-02 0.35325791E-02 0.35329490E-02 0.47120000E+00 0.10626543E-01 0.35430281E-02 0.35415719E-02 0.35419429E-02 0.47140000E+00 0.10653619E-01 0.35520554E-02 0.35505956E-02 0.35509678E-02 0.47160000E+00 0.10680788E-01 0.35611138E-02 0.35596506E-02 0.35600238E-02 0.47180000E+00 0.10708052E-01 0.35702036E-02 0.35687368E-02 0.35691111E-02 0.47200000E+00 0.10735409E-01 0.35793248E-02 0.35778545E-02 0.35782299E-02 0.47220000E+00 0.10762862E-01 0.35884777E-02 0.35870037E-02 0.35873802E-02 0.47240000E+00 0.10790409E-01 0.35976622E-02 0.35961847E-02 0.35965623E-02 0.47260000E+00 0.10818052E-01 0.36068787E-02 0.36053975E-02 0.36057763E-02 0.47280000E+00 0.10845792E-01 0.36161271E-02 0.36146424E-02 0.36150222E-02 0.47300000E+00 0.10873628E-01 0.36254078E-02 0.36239194E-02 0.36243004E-02 0.47320000E+00 0.10901560E-01 0.36347207E-02 0.36332288E-02 0.36336109E-02 0.47340000E+00 0.10929591E-01 0.36440662E-02 0.36425706E-02 0.36429538E-02 0.47360000E+00 0.10957719E-01 0.36534443E-02 0.36519450E-02 0.36523294E-02 0.47380000E+00 0.10985945E-01 0.36628551E-02 0.36613522E-02 0.36617377E-02 0.47400000E+00 0.11014270E-01 0.36722989E-02 0.36707923E-02 0.36711790E-02 0.47420000E+00 0.11042695E-01 0.36817758E-02 0.36802655E-02 0.36806533E-02 0.47440000E+00 0.11071219E-01 0.36912859E-02 0.36897719E-02 0.36901609E-02 0.47460000E+00 0.11099843E-01 0.37008294E-02 0.36993117E-02 0.36997018E-02 0.47480000E+00 0.11128568E-01 0.37104065E-02 0.37088851E-02 0.37092763E-02 0.47500000E+00 0.11157394E-01 0.37200173E-02 0.37184921E-02 0.37188846E-02 0.47520000E+00 0.11186321E-01 0.37296619E-02 0.37281330E-02 0.37285266E-02 0.47540000E+00 0.11215351E-01 0.37393406E-02 0.37378079E-02 0.37382027E-02 0.47560000E+00 0.11244483E-01 0.37490534E-02 0.37475169E-02 0.37479129E-02 0.47580000E+00 0.11273718E-01 0.37588006E-02 0.37572603E-02 0.37576575E-02 0.47600000E+00 0.11303057E-01 0.37685823E-02 0.37670382E-02 0.37674366E-02 0.47620000E+00 0.11332500E-01 0.37783987E-02 0.37768508E-02 0.37772504E-02 0.47640000E+00 0.11362047E-01 0.37882499E-02 0.37866982E-02 0.37870989E-02 0.47660000E+00 0.11391699E-01 0.37981361E-02 0.37965805E-02 0.37969825E-02 0.47680000E+00 0.11421457E-01 0.38080574E-02 0.38064980E-02 0.38069012E-02 0.47700000E+00 0.11451320E-01 0.38180141E-02 0.38164509E-02 0.38168553E-02 0.47720000E+00 0.11481290E-01 0.38280063E-02 0.38264392E-02 0.38268448E-02 0.47740000E+00 0.11511367E-01 0.38380342E-02 0.38364631E-02 0.38368700E-02 0.47760000E+00 0.11541552E-01 0.38480979E-02 0.38465229E-02 0.38469310E-02 0.47780000E+00 0.11571844E-01 0.38581976E-02 0.38566187E-02 0.38570280E-02 0.47800000E+00 0.11602245E-01 0.38683334E-02 0.38667506E-02 0.38671612E-02 0.47820000E+00 0.11632755E-01 0.38785057E-02 0.38769189E-02 0.38773307E-02 0.47840000E+00 0.11663375E-01 0.38887144E-02 0.38871237E-02 0.38875368E-02 0.47860000E+00 0.11694105E-01 0.38989599E-02 0.38973652E-02 0.38977795E-02 0.47880000E+00 0.11724945E-01 0.39092422E-02 0.39076435E-02 0.39080591E-02 0.47900000E+00 0.11755896E-01 0.39195616E-02 0.39179589E-02 0.39183757E-02 0.47920000E+00 0.11786959E-01 0.39299182E-02 0.39283114E-02 0.39287296E-02 0.47940000E+00 0.11818134E-01 0.39403122E-02 0.39387014E-02 0.39391208E-02 0.47960000E+00 0.11849422E-01 0.39507438E-02 0.39491290E-02 0.39495497E-02 0.47980000E+00 0.11880824E-01 0.39612131E-02 0.39595943E-02 0.39600163E-02 0.48000000E+00 0.11912339E-01 0.39717204E-02 0.39700975E-02 0.39705208E-02 0.48020000E+00 0.11943968E-01 0.39822659E-02 0.39806389E-02 0.39810635E-02 0.48040000E+00 0.11975713E-01 0.39928496E-02 0.39912186E-02 0.39916444E-02 0.48060000E+00 0.12007573E-01 0.40034719E-02 0.40018367E-02 0.40022639E-02 0.48080000E+00 0.12039548E-01 0.40141329E-02 0.40124935E-02 0.40129220E-02 0.48100000E+00 0.12071641E-01 0.40248327E-02 0.40231892E-02 0.40236191E-02 0.48120000E+00 0.12103851E-01 0.40355716E-02 0.40339240E-02 0.40343551E-02 0.48140000E+00 0.12136178E-01 0.40463498E-02 0.40446980E-02 0.40451305E-02 0.48160000E+00 0.12168624E-01 0.40571674E-02 0.40555114E-02 0.40559452E-02 0.48180000E+00 0.12201189E-01 0.40680247E-02 0.40663645E-02 0.40667996E-02 0.48200000E+00 0.12233873E-01 0.40789218E-02 0.40772574E-02 0.40776939E-02 0.48220000E+00 0.12266677E-01 0.40898589E-02 0.40881903E-02 0.40886281E-02 0.48240000E+00 0.12299602E-01 0.41008362E-02 0.40991634E-02 0.40996026E-02 0.48260000E+00 0.12332648E-01 0.41118540E-02 0.41101769E-02 0.41106174E-02 0.48280000E+00 0.12365816E-01 0.41229124E-02 0.41212310E-02 0.41216729E-02 0.48300000E+00 0.12399107E-01 0.41340116E-02 0.41323259E-02 0.41327692E-02 0.48320000E+00 0.12432520E-01 0.41451518E-02 0.41434619E-02 0.41439066E-02 0.48340000E+00 0.12466057E-01 0.41563333E-02 0.41546390E-02 0.41550851E-02 0.48360000E+00 0.12499719E-01 0.41675562E-02 0.41658576E-02 0.41663050E-02 0.48380000E+00 0.12533505E-01 0.41788207E-02 0.41771177E-02 0.41775666E-02 0.48400000E+00 0.12567417E-01 0.41901271E-02 0.41884197E-02 0.41888700E-02 0.48420000E+00 0.12601455E-01 0.42014755E-02 0.41997638E-02 0.42002155E-02 0.48440000E+00 0.12635619E-01 0.42128662E-02 0.42111500E-02 0.42116032E-02 0.48460000E+00 0.12669911E-01 0.42242993E-02 0.42225788E-02 0.42230333E-02 0.48480000E+00 0.12704331E-01 0.42357751E-02 0.42340502E-02 0.42345061E-02 0.48500000E+00 0.12738880E-01 0.42472938E-02 0.42455644E-02 0.42460218E-02 0.48520000E+00 0.12773558E-01 0.42588556E-02 0.42571217E-02 0.42575806E-02 0.48540000E+00 0.12808366E-01 0.42704607E-02 0.42687224E-02 0.42691827E-02 0.48560000E+00 0.12843304E-01 0.42821094E-02 0.42803666E-02 0.42808283E-02 0.48580000E+00 0.12878374E-01 0.42938018E-02 0.42920545E-02 0.42925176E-02 0.48600000E+00 0.12913575E-01 0.43055382E-02 0.43037863E-02 0.43042510E-02 0.48620000E+00 0.12948910E-01 0.43173187E-02 0.43155623E-02 0.43160285E-02 0.48640000E+00 0.12984377E-01 0.43291437E-02 0.43273828E-02 0.43278504E-02 0.48660000E+00 0.13019978E-01 0.43410133E-02 0.43392478E-02 0.43397169E-02 0.48680000E+00 0.13055714E-01 0.43529278E-02 0.43511577E-02 0.43516283E-02 0.48700000E+00 0.13091585E-01 0.43648874E-02 0.43631127E-02 0.43635848E-02 0.48720000E+00 0.13127592E-01 0.43768923E-02 0.43751130E-02 0.43755865E-02 0.48740000E+00 0.13163735E-01 0.43889427E-02 0.43871588E-02 0.43876339E-02 0.48760000E+00 0.13200016E-01 0.44010389E-02 0.43992503E-02 0.43997269E-02 0.48780000E+00 0.13236435E-01 0.44131811E-02 0.44113879E-02 0.44118660E-02 0.48800000E+00 0.13272993E-01 0.44253696E-02 0.44235717E-02 0.44240513E-02 0.48820000E+00 0.13309690E-01 0.44376046E-02 0.44358019E-02 0.44362831E-02 0.48840000E+00 0.13346527E-01 0.44498862E-02 0.44480788E-02 0.44485616E-02 0.48860000E+00 0.13383505E-01 0.44622148E-02 0.44604027E-02 0.44608870E-02 0.48880000E+00 0.13420624E-01 0.44745906E-02 0.44727738E-02 0.44732596E-02 0.48900000E+00 0.13457886E-01 0.44870139E-02 0.44851922E-02 0.44856796E-02 0.48920000E+00 0.13495290E-01 0.44994848E-02 0.44976583E-02 0.44981473E-02 0.48940000E+00 0.13532839E-01 0.45120036E-02 0.45101724E-02 0.45106629E-02 0.48960000E+00 0.13570532E-01 0.45245706E-02 0.45227346E-02 0.45232267E-02 0.48980000E+00 0.13608370E-01 0.45371860E-02 0.45353451E-02 0.45358389E-02 0.49000000E+00 0.13646354E-01 0.45498501E-02 0.45480044E-02 0.45484997E-02 0.49020000E+00 0.13684485E-01 0.45625631E-02 0.45607125E-02 0.45612094E-02 0.49040000E+00 0.13722763E-01 0.45753253E-02 0.45734697E-02 0.45739683E-02 0.49060000E+00 0.13761190E-01 0.45881369E-02 0.45862764E-02 0.45867766E-02 0.49080000E+00 0.13799765E-01 0.46009981E-02 0.45991328E-02 0.45996345E-02 0.49100000E+00 0.13838491E-01 0.46139093E-02 0.46120390E-02 0.46125424E-02 0.49120000E+00 0.13877367E-01 0.46268707E-02 0.46249954E-02 0.46255005E-02 0.49140000E+00 0.13916394E-01 0.46398826E-02 0.46380023E-02 0.46385090E-02 0.49160000E+00 0.13955573E-01 0.46529451E-02 0.46510598E-02 0.46515682E-02 0.49180000E+00 0.13994905E-01 0.46660587E-02 0.46641684E-02 0.46646784E-02 0.49200000E+00 0.14034391E-01 0.46792235E-02 0.46773281E-02 0.46778398E-02 0.49220000E+00 0.14074032E-01 0.46924398E-02 0.46905394E-02 0.46910527E-02 0.49240000E+00 0.14113828E-01 0.47057079E-02 0.47038024E-02 0.47043174E-02 0.49260000E+00 0.14153780E-01 0.47190280E-02 0.47171174E-02 0.47176341E-02 0.49280000E+00 0.14193888E-01 0.47324005E-02 0.47304848E-02 0.47310032E-02 0.49300000E+00 0.14234155E-01 0.47458256E-02 0.47439047E-02 0.47444248E-02 0.49320000E+00 0.14274580E-01 0.47593035E-02 0.47573775E-02 0.47578993E-02 0.49340000E+00 0.14315165E-01 0.47728346E-02 0.47709035E-02 0.47714270E-02 0.49360000E+00 0.14355910E-01 0.47864192E-02 0.47844828E-02 0.47850081E-02 0.49380000E+00 0.14396816E-01 0.48000575E-02 0.47981159E-02 0.47986429E-02 0.49400000E+00 0.14437884E-01 0.48137497E-02 0.48118029E-02 0.48123317E-02 0.49420000E+00 0.14479115E-01 0.48274963E-02 0.48255442E-02 0.48260748E-02 0.49440000E+00 0.14520510E-01 0.48412975E-02 0.48393401E-02 0.48398724E-02 0.49460000E+00 0.14562069E-01 0.48551535E-02 0.48531908E-02 0.48537249E-02 0.49480000E+00 0.14603794E-01 0.48690647E-02 0.48670967E-02 0.48676325E-02 0.49500000E+00 0.14645685E-01 0.48830313E-02 0.48810580E-02 0.48815956E-02 0.49520000E+00 0.14687743E-01 0.48970537E-02 0.48950750E-02 0.48956144E-02 0.49540000E+00 0.14729970E-01 0.49111321E-02 0.49091481E-02 0.49096893E-02 0.49560000E+00 0.14772365E-01 0.49252669E-02 0.49232775E-02 0.49238205E-02 0.49580000E+00 0.14814930E-01 0.49394583E-02 0.49374635E-02 0.49380083E-02 0.49600000E+00 0.14857666E-01 0.49537067E-02 0.49517064E-02 0.49522531E-02 0.49620000E+00 0.14900574E-01 0.49680124E-02 0.49660066E-02 0.49665551E-02 0.49640000E+00 0.14943655E-01 0.49823756E-02 0.49803644E-02 0.49809147E-02 0.49660000E+00 0.14986909E-01 0.49967966E-02 0.49947800E-02 0.49953321E-02 0.49680000E+00 0.15030337E-01 0.50112759E-02 0.50092537E-02 0.50098077E-02 0.49700000E+00 0.15073941E-01 0.50258137E-02 0.50237859E-02 0.50243418E-02 0.49720000E+00 0.15117722E-01 0.50404103E-02 0.50383770E-02 0.50389347E-02 0.49740000E+00 0.15161680E-01 0.50550660E-02 0.50530271E-02 0.50535868E-02 0.49760000E+00 0.15205816E-01 0.50697812E-02 0.50677367E-02 0.50682983E-02 0.49780000E+00 0.15250132E-01 0.50845562E-02 0.50825061E-02 0.50830695E-02 0.49800000E+00 0.15294628E-01 0.50993913E-02 0.50973355E-02 0.50979008E-02 0.49820000E+00 0.15339305E-01 0.51142868E-02 0.51122253E-02 0.51127926E-02 0.49840000E+00 0.15384164E-01 0.51292431E-02 0.51271759E-02 0.51277451E-02 0.49860000E+00 0.15429207E-01 0.51442604E-02 0.51421876E-02 0.51427587E-02 0.49880000E+00 0.15474434E-01 0.51593392E-02 0.51572607E-02 0.51578337E-02 0.49900000E+00 0.15519846E-01 0.51744798E-02 0.51723955E-02 0.51729705E-02 0.49920000E+00 0.15565444E-01 0.51896825E-02 0.51875924E-02 0.51881693E-02 0.49940000E+00 0.15611230E-01 0.52049476E-02 0.52028517E-02 0.52034306E-02 0.49960000E+00 0.15657204E-01 0.52202755E-02 0.52181738E-02 0.52187547E-02 0.49980000E+00 0.15703367E-01 0.52356666E-02 0.52335590E-02 0.52341419E-02 0.50000000E+00 0.15749721E-01 0.52511211E-02 0.52490076E-02 0.52495925E-02 0.50020000E+00 0.15796267E-01 0.52666394E-02 0.52645201E-02 0.52651070E-02 0.50040000E+00 0.15843004E-01 0.52822220E-02 0.52800967E-02 0.52806857E-02 0.50060000E+00 0.15889936E-01 0.52978691E-02 0.52957379E-02 0.52963289E-02 0.50080000E+00 0.15937062E-01 0.53135811E-02 0.53114439E-02 0.53120369E-02 0.50100000E+00 0.15984384E-01 0.53293583E-02 0.53272152E-02 0.53278102E-02 0.50120000E+00 0.16031902E-01 0.53452012E-02 0.53430520E-02 0.53436492E-02 0.50140000E+00 0.16079619E-01 0.53611101E-02 0.53589549E-02 0.53595541E-02 0.50160000E+00 0.16127535E-01 0.53770853E-02 0.53749241E-02 0.53755253E-02 0.50180000E+00 0.16175650E-01 0.53931273E-02 0.53909599E-02 0.53915633E-02 0.50200000E+00 0.16223968E-01 0.54092363E-02 0.54070629E-02 0.54076683E-02 0.50220000E+00 0.16272487E-01 0.54254129E-02 0.54232333E-02 0.54238408E-02 0.50240000E+00 0.16321210E-01 0.54416573E-02 0.54394715E-02 0.54400812E-02 0.50260000E+00 0.16370138E-01 0.54579699E-02 0.54557780E-02 0.54563898E-02 0.50280000E+00 0.16419271E-01 0.54743512E-02 0.54721531E-02 0.54727670E-02 0.50300000E+00 0.16468612E-01 0.54908015E-02 0.54885971E-02 0.54892132E-02 0.50320000E+00 0.16518160E-01 0.55073211E-02 0.55051105E-02 0.55057287E-02 0.50340000E+00 0.16567918E-01 0.55239106E-02 0.55216937E-02 0.55223141E-02 0.50360000E+00 0.16617887E-01 0.55405702E-02 0.55383471E-02 0.55389696E-02 0.50380000E+00 0.16668067E-01 0.55573005E-02 0.55550710E-02 0.55556957E-02 0.50400000E+00 0.16718460E-01 0.55741017E-02 0.55718658E-02 0.55724928E-02 0.50420000E+00 0.16769068E-01 0.55909743E-02 0.55887321E-02 0.55893612E-02 0.50440000E+00 0.16819890E-01 0.56079187E-02 0.56056701E-02 0.56063014E-02 0.50460000E+00 0.16870930E-01 0.56249354E-02 0.56226803E-02 0.56233139E-02 0.50480000E+00 0.16922187E-01 0.56420246E-02 0.56397631E-02 0.56403989E-02 0.50500000E+00 0.16973663E-01 0.56591869E-02 0.56569189E-02 0.56575569E-02 0.50520000E+00 0.17025359E-01 0.56764226E-02 0.56741481E-02 0.56747884E-02 0.50540000E+00 0.17077277E-01 0.56937322E-02 0.56914511E-02 0.56920937E-02 0.50560000E+00 0.17129418E-01 0.57111161E-02 0.57088285E-02 0.57094734E-02 0.50580000E+00 0.17181783E-01 0.57285748E-02 0.57262805E-02 0.57269277E-02 0.50600000E+00 0.17234373E-01 0.57461085E-02 0.57438077E-02 0.57444572E-02 0.50620000E+00 0.17287191E-01 0.57637179E-02 0.57614104E-02 0.57620622E-02 0.50640000E+00 0.17340236E-01 0.57814033E-02 0.57790892E-02 0.57797433E-02 0.50660000E+00 0.17393510E-01 0.57991652E-02 0.57968444E-02 0.57975008E-02 0.50680000E+00 0.17447016E-01 0.58170040E-02 0.58146764E-02 0.58153352E-02 0.50700000E+00 0.17500753E-01 0.58349202E-02 0.58325858E-02 0.58332470E-02 0.50720000E+00 0.17554724E-01 0.58529141E-02 0.58505730E-02 0.58512366E-02 0.50740000E+00 0.17608929E-01 0.58709864E-02 0.58686384E-02 0.58693044E-02 0.50760000E+00 0.17663371E-01 0.58891373E-02 0.58867825E-02 0.58874509E-02 0.50780000E+00 0.17718050E-01 0.59073674E-02 0.59050058E-02 0.59056765E-02 0.50800000E+00 0.17772968E-01 0.59256772E-02 0.59233087E-02 0.59239818E-02 0.50820000E+00 0.17828126E-01 0.59440671E-02 0.59416916E-02 0.59423672E-02 0.50840000E+00 0.17883526E-01 0.59625375E-02 0.59601551E-02 0.59608332E-02 0.50860000E+00 0.17939169E-01 0.59810891E-02 0.59786997E-02 0.59793802E-02 0.50880000E+00 0.17995056E-01 0.59997221E-02 0.59973257E-02 0.59980087E-02 0.50900000E+00 0.18051190E-01 0.60184372E-02 0.60160337E-02 0.60167192E-02 0.50920000E+00 0.18107571E-01 0.60372347E-02 0.60348242E-02 0.60355122E-02 0.50940000E+00 0.18164201E-01 0.60561153E-02 0.60536977E-02 0.60543881E-02 0.50960000E+00 0.18221081E-01 0.60750793E-02 0.60726545E-02 0.60733475E-02 0.50980000E+00 0.18278214E-01 0.60941273E-02 0.60916954E-02 0.60923909E-02 0.51000000E+00 0.18335599E-01 0.61132597E-02 0.61108207E-02 0.61115187E-02 0.51020000E+00 0.18393240E-01 0.61324772E-02 0.61300309E-02 0.61307315E-02 0.51040000E+00 0.18451136E-01 0.61517801E-02 0.61493265E-02 0.61500297E-02 0.51060000E+00 0.18509291E-01 0.61711690E-02 0.61687082E-02 0.61694139E-02 0.51080000E+00 0.18567705E-01 0.61906444E-02 0.61881763E-02 0.61888846E-02 0.51100000E+00 0.18626381E-01 0.62102069E-02 0.62077314E-02 0.62084423E-02 0.51120000E+00 0.18685318E-01 0.62298569E-02 0.62273740E-02 0.62280876E-02 0.51140000E+00 0.18744520E-01 0.62495949E-02 0.62471046E-02 0.62478209E-02 0.51160000E+00 0.18803988E-01 0.62694216E-02 0.62669239E-02 0.62676427E-02 0.51180000E+00 0.18863723E-01 0.62893374E-02 0.62868322E-02 0.62875537E-02 0.51200000E+00 0.18923727E-01 0.63093429E-02 0.63068302E-02 0.63075544E-02 0.51220000E+00 0.18984002E-01 0.63294385E-02 0.63269183E-02 0.63276452E-02 0.51240000E+00 0.19044549E-01 0.63496250E-02 0.63470972E-02 0.63478268E-02 0.51260000E+00 0.19105370E-01 0.63699028E-02 0.63673674E-02 0.63680997E-02 0.51280000E+00 0.19166466E-01 0.63902724E-02 0.63877294E-02 0.63884644E-02 0.51300000E+00 0.19227840E-01 0.64107345E-02 0.64081838E-02 0.64089216E-02 0.51320000E+00 0.19289492E-01 0.64312895E-02 0.64287311E-02 0.64294717E-02 0.51340000E+00 0.19351425E-01 0.64519381E-02 0.64493720E-02 0.64501153E-02 0.51360000E+00 0.19413641E-01 0.64726809E-02 0.64701070E-02 0.64708531E-02 0.51380000E+00 0.19476141E-01 0.64935183E-02 0.64909367E-02 0.64916856E-02 0.51400000E+00 0.19538926E-01 0.65144510E-02 0.65118616E-02 0.65126133E-02 0.51420000E+00 0.19601999E-01 0.65354797E-02 0.65328823E-02 0.65336369E-02 0.51440000E+00 0.19665361E-01 0.65566047E-02 0.65539995E-02 0.65547569E-02 0.51460000E+00 0.19729014E-01 0.65778269E-02 0.65752137E-02 0.65759739E-02 0.51480000E+00 0.19792961E-01 0.65991466E-02 0.65965255E-02 0.65972886E-02 0.51500000E+00 0.19857202E-01 0.66205647E-02 0.66179356E-02 0.66187016E-02 0.51520000E+00 0.19921739E-01 0.66420816E-02 0.66394444E-02 0.66402134E-02 0.51540000E+00 0.19986575E-01 0.66636980E-02 0.66610528E-02 0.66618246E-02 0.51560000E+00 0.20051712E-01 0.66854145E-02 0.66827612E-02 0.66835359E-02 0.51580000E+00 0.20117150E-01 0.67072318E-02 0.67045703E-02 0.67053480E-02 0.51600000E+00 0.20182892E-01 0.67291503E-02 0.67264807E-02 0.67272613E-02 0.51620000E+00 0.20248941E-01 0.67511709E-02 0.67484930E-02 0.67492767E-02 0.51640000E+00 0.20315297E-01 0.67732941E-02 0.67706080E-02 0.67713946E-02 0.51660000E+00 0.20381962E-01 0.67955205E-02 0.67928261E-02 0.67936158E-02 0.51680000E+00 0.20448940E-01 0.68178509E-02 0.68151482E-02 0.68159409E-02 0.51700000E+00 0.20516231E-01 0.68402859E-02 0.68375747E-02 0.68383705E-02 0.51720000E+00 0.20583838E-01 0.68628260E-02 0.68601065E-02 0.68609053E-02 0.51740000E+00 0.20651762E-01 0.68854721E-02 0.68827441E-02 0.68835460E-02 0.51760000E+00 0.20720006E-01 0.69082247E-02 0.69054882E-02 0.69062932E-02 0.51780000E+00 0.20788572E-01 0.69310845E-02 0.69283396E-02 0.69291477E-02 0.51800000E+00 0.20857461E-01 0.69540523E-02 0.69512988E-02 0.69521100E-02 0.51820000E+00 0.20926676E-01 0.69771286E-02 0.69743665E-02 0.69751809E-02 0.51840000E+00 0.20996219E-01 0.70003142E-02 0.69975435E-02 0.69983610E-02 0.51860000E+00 0.21066091E-01 0.70236098E-02 0.70208305E-02 0.70216512E-02 0.51880000E+00 0.21136296E-01 0.70470161E-02 0.70442281E-02 0.70450520E-02 0.51900000E+00 0.21206835E-01 0.70705338E-02 0.70677370E-02 0.70685641E-02 0.51920000E+00 0.21277710E-01 0.70941636E-02 0.70913580E-02 0.70921883E-02 0.51940000E+00 0.21348923E-01 0.71179062E-02 0.71150918E-02 0.71159254E-02 0.51960000E+00 0.21420477E-01 0.71417624E-02 0.71389391E-02 0.71397759E-02 0.51980000E+00 0.21492374E-01 0.71657329E-02 0.71629007E-02 0.71637408E-02 0.52000000E+00 0.21564616E-01 0.71898183E-02 0.71869772E-02 0.71878206E-02 0.52020000E+00 0.21637205E-01 0.72140195E-02 0.72111694E-02 0.72120161E-02 0.52040000E+00 0.21710143E-01 0.72383372E-02 0.72354781E-02 0.72363281E-02 0.52060000E+00 0.21783434E-01 0.72627722E-02 0.72599040E-02 0.72607574E-02 0.52080000E+00 0.21857078E-01 0.72873252E-02 0.72844479E-02 0.72853047E-02 0.52100000E+00 0.21931078E-01 0.73119970E-02 0.73091105E-02 0.73099707E-02 0.52120000E+00 0.22005437E-01 0.73367883E-02 0.73338927E-02 0.73347562E-02 0.52140000E+00 0.22080157E-01 0.73617000E-02 0.73587951E-02 0.73596621E-02 0.52160000E+00 0.22155241E-01 0.73867328E-02 0.73838186E-02 0.73846891E-02 0.52180000E+00 0.22230690E-01 0.74118876E-02 0.74089641E-02 0.74098380E-02 0.52200000E+00 0.22306507E-01 0.74371650E-02 0.74342321E-02 0.74351095E-02 0.52220000E+00 0.22382694E-01 0.74625660E-02 0.74596237E-02 0.74605046E-02 0.52240000E+00 0.22459255E-01 0.74880913E-02 0.74851396E-02 0.74860240E-02 0.52260000E+00 0.22536191E-01 0.75137417E-02 0.75107805E-02 0.75116685E-02 0.52280000E+00 0.22613505E-01 0.75395182E-02 0.75365474E-02 0.75374389E-02 0.52300000E+00 0.22691199E-01 0.75654214E-02 0.75624411E-02 0.75633362E-02 0.52320000E+00 0.22769276E-01 0.75914523E-02 0.75884624E-02 0.75893611E-02 0.52340000E+00 0.22847738E-01 0.76176117E-02 0.76146121E-02 0.76155144E-02 0.52360000E+00 0.22926589E-01 0.76439005E-02 0.76408911E-02 0.76417971E-02 0.52380000E+00 0.23005830E-01 0.76703195E-02 0.76673003E-02 0.76682100E-02 0.52400000E+00 0.23085464E-01 0.76968695E-02 0.76938406E-02 0.76947539E-02 0.52420000E+00 0.23165494E-01 0.77235515E-02 0.77205127E-02 0.77214297E-02 0.52440000E+00 0.23245922E-01 0.77503664E-02 0.77473177E-02 0.77482384E-02 0.52460000E+00 0.23326752E-01 0.77773150E-02 0.77742563E-02 0.77751808E-02 0.52480000E+00 0.23407985E-01 0.78043982E-02 0.78013295E-02 0.78022578E-02 0.52500000E+00 0.23489625E-01 0.78316169E-02 0.78285382E-02 0.78294702E-02 0.52520000E+00 0.23571675E-01 0.78589721E-02 0.78558833E-02 0.78568192E-02 0.52540000E+00 0.23654136E-01 0.78864647E-02 0.78833657E-02 0.78843054E-02 0.52560000E+00 0.23737012E-01 0.79140956E-02 0.79109864E-02 0.79119299E-02 0.52580000E+00 0.23820306E-01 0.79418657E-02 0.79387463E-02 0.79396937E-02 0.52600000E+00 0.23904020E-01 0.79697759E-02 0.79666463E-02 0.79675975E-02 0.52620000E+00 0.23988157E-01 0.79978273E-02 0.79946873E-02 0.79956425E-02 0.52640000E+00 0.24072721E-01 0.80260208E-02 0.80228704E-02 0.80238296E-02 0.52660000E+00 0.24157714E-01 0.80543574E-02 0.80511966E-02 0.80521597E-02 0.52680000E+00 0.24243138E-01 0.80828380E-02 0.80796667E-02 0.80806338E-02 0.52700000E+00 0.24328998E-01 0.81114636E-02 0.81082818E-02 0.81092529E-02 0.52720000E+00 0.24415296E-01 0.81402353E-02 0.81370428E-02 0.81380180E-02 0.52740000E+00 0.24502035E-01 0.81691540E-02 0.81659509E-02 0.81669300E-02 0.52760000E+00 0.24589218E-01 0.81982207E-02 0.81950069E-02 0.81959901E-02 0.52780000E+00 0.24676848E-01 0.82274364E-02 0.82242119E-02 0.82251993E-02 0.52800000E+00 0.24764928E-01 0.82568023E-02 0.82535670E-02 0.82545584E-02 0.52820000E+00 0.24853461E-01 0.82863193E-02 0.82830731E-02 0.82840687E-02 0.52840000E+00 0.24942451E-01 0.83159884E-02 0.83127313E-02 0.83137312E-02 0.52860000E+00 0.25031900E-01 0.83458108E-02 0.83425428E-02 0.83435468E-02 0.52880000E+00 0.25121813E-01 0.83757875E-02 0.83725084E-02 0.83735167E-02 0.52900000E+00 0.25212191E-01 0.84059196E-02 0.84026294E-02 0.84036419E-02 0.52920000E+00 0.25303038E-01 0.84362081E-02 0.84329068E-02 0.84339236E-02 0.52940000E+00 0.25394359E-01 0.84666541E-02 0.84633417E-02 0.84643627E-02 0.52960000E+00 0.25486155E-01 0.84972588E-02 0.84939352E-02 0.84949606E-02 0.52980000E+00 0.25578430E-01 0.85280233E-02 0.85246884E-02 0.85257181E-02 0.53000000E+00 0.25671188E-01 0.85589487E-02 0.85556024E-02 0.85566365E-02 0.53020000E+00 0.25764431E-01 0.85900361E-02 0.85866784E-02 0.85877169E-02 0.53040000E+00 0.25858165E-01 0.86212867E-02 0.86179176E-02 0.86189605E-02 0.53060000E+00 0.25952391E-01 0.86527016E-02 0.86493210E-02 0.86503683E-02 0.53080000E+00 0.26047113E-01 0.86842820E-02 0.86808898E-02 0.86819416E-02 0.53100000E+00 0.26142336E-01 0.87160291E-02 0.87126252E-02 0.87136816E-02 0.53120000E+00 0.26238062E-01 0.87479440E-02 0.87445284E-02 0.87455893E-02 0.53140000E+00 0.26334295E-01 0.87800279E-02 0.87766007E-02 0.87776661E-02 0.53160000E+00 0.26431038E-01 0.88122821E-02 0.88088431E-02 0.88099131E-02 0.53180000E+00 0.26528296E-01 0.88447078E-02 0.88412569E-02 0.88423315E-02 0.53200000E+00 0.26626072E-01 0.88773062E-02 0.88738433E-02 0.88749226E-02 0.53220000E+00 0.26724370E-01 0.89100785E-02 0.89066037E-02 0.89076876E-02 0.53240000E+00 0.26823193E-01 0.89430260E-02 0.89395391E-02 0.89406278E-02 0.53260000E+00 0.26922545E-01 0.89761500E-02 0.89726510E-02 0.89737443E-02 0.53280000E+00 0.27022431E-01 0.90094517E-02 0.90059405E-02 0.90070386E-02 0.53300000E+00 0.27122853E-01 0.90429324E-02 0.90394090E-02 0.90405119E-02 0.53320000E+00 0.27223817E-01 0.90765934E-02 0.90730577E-02 0.90741654E-02 0.53340000E+00 0.27325325E-01 0.91104361E-02 0.91068880E-02 0.91080005E-02 0.53360000E+00 0.27427381E-01 0.91444616E-02 0.91409012E-02 0.91420186E-02 0.53380000E+00 0.27529991E-01 0.91786715E-02 0.91750985E-02 0.91762208E-02 0.53400000E+00 0.27633157E-01 0.92130670E-02 0.92094814E-02 0.92106087E-02 0.53420000E+00 0.27736884E-01 0.92476494E-02 0.92440513E-02 0.92451835E-02 0.53440000E+00 0.27841176E-01 0.92824202E-02 0.92788094E-02 0.92799466E-02 0.53460000E+00 0.27946037E-01 0.93173807E-02 0.93137572E-02 0.93148994E-02 0.53480000E+00 0.28051472E-01 0.93525324E-02 0.93488960E-02 0.93500433E-02 0.53500000E+00 0.28157484E-01 0.93878766E-02 0.93842273E-02 0.93853797E-02 0.53520000E+00 0.28264077E-01 0.94234147E-02 0.94197525E-02 0.94209100E-02 0.53540000E+00 0.28371257E-01 0.94591483E-02 0.94554731E-02 0.94566357E-02 0.53560000E+00 0.28479027E-01 0.94950787E-02 0.94913904E-02 0.94925582E-02 0.53580000E+00 0.28587392E-01 0.95312074E-02 0.95275059E-02 0.95286789E-02 0.53600000E+00 0.28696356E-01 0.95675358E-02 0.95638212E-02 0.95649994E-02 0.53620000E+00 0.28805924E-01 0.96040656E-02 0.96003376E-02 0.96015212E-02 0.53640000E+00 0.28916101E-01 0.96407981E-02 0.96370568E-02 0.96382456E-02 0.53660000E+00 0.29026889E-01 0.96777349E-02 0.96739802E-02 0.96751744E-02 0.53680000E+00 0.29138296E-01 0.97148776E-02 0.97111093E-02 0.97123089E-02 0.53700000E+00 0.29250324E-01 0.97522276E-02 0.97484458E-02 0.97496507E-02 0.53720000E+00 0.29362979E-01 0.97897865E-02 0.97859911E-02 0.97872015E-02 0.53740000E+00 0.29476266E-01 0.98275560E-02 0.98237468E-02 0.98249627E-02 0.53760000E+00 0.29590188E-01 0.98655376E-02 0.98617146E-02 0.98629360E-02 0.53780000E+00 0.29704752E-01 0.99037328E-02 0.98998960E-02 0.99011230E-02 0.53800000E+00 0.29819961E-01 0.99421434E-02 0.99382927E-02 0.99395252E-02 0.53820000E+00 0.29935822E-01 0.99807710E-02 0.99769062E-02 0.99781444E-02 0.53840000E+00 0.30052338E-01 0.10019617E-01 0.10015738E-01 0.10016982E-01 0.53860000E+00 0.30169515E-01 0.10058684E-01 0.10054791E-01 0.10056040E-01 0.53880000E+00 0.30287357E-01 0.10097972E-01 0.10094065E-01 0.10095320E-01 0.53900000E+00 0.30405871E-01 0.10137484E-01 0.10133563E-01 0.10134824E-01 0.53920000E+00 0.30525060E-01 0.10177222E-01 0.10173286E-01 0.10174553E-01 0.53940000E+00 0.30644931E-01 0.10217187E-01 0.10213236E-01 0.10214509E-01 0.53960000E+00 0.30765489E-01 0.10257380E-01 0.10253415E-01 0.10254694E-01 0.53980000E+00 0.30886738E-01 0.10297804E-01 0.10293825E-01 0.10295109E-01 0.54000000E+00 0.31008685E-01 0.10338461E-01 0.10334467E-01 0.10335757E-01 0.54020000E+00 0.31131334E-01 0.10379352E-01 0.10375343E-01 0.10376639E-01 0.54040000E+00 0.31254691E-01 0.10420479E-01 0.10416455E-01 0.10417757E-01 0.54060000E+00 0.31378762E-01 0.10461844E-01 0.10457805E-01 0.10459113E-01 0.54080000E+00 0.31503552E-01 0.10503448E-01 0.10499394E-01 0.10500709E-01 0.54100000E+00 0.31629067E-01 0.10545295E-01 0.10541226E-01 0.10542546E-01 0.54120000E+00 0.31755312E-01 0.10587385E-01 0.10583300E-01 0.10584627E-01 0.54140000E+00 0.31882293E-01 0.10629720E-01 0.10625620E-01 0.10626953E-01 0.54160000E+00 0.32010017E-01 0.10672302E-01 0.10668187E-01 0.10669527E-01 0.54180000E+00 0.32138488E-01 0.10715134E-01 0.10711004E-01 0.10712350E-01 0.54200000E+00 0.32267713E-01 0.10758218E-01 0.10754072E-01 0.10755424E-01 0.54220000E+00 0.32397698E-01 0.10801554E-01 0.10797392E-01 0.10798751E-01 0.54240000E+00 0.32528448E-01 0.10845146E-01 0.10840969E-01 0.10842334E-01 0.54260000E+00 0.32659970E-01 0.10888995E-01 0.10884802E-01 0.10886173E-01 0.54280000E+00 0.32792271E-01 0.10933104E-01 0.10928895E-01 0.10930273E-01 0.54300000E+00 0.32925355E-01 0.10977474E-01 0.10973249E-01 0.10974633E-01 0.54320000E+00 0.33059230E-01 0.11022107E-01 0.11017866E-01 0.11019257E-01 0.54340000E+00 0.33193902E-01 0.11067006E-01 0.11062749E-01 0.11064147E-01 0.54360000E+00 0.33329377E-01 0.11112173E-01 0.11107900E-01 0.11109304E-01 0.54380000E+00 0.33465662E-01 0.11157610E-01 0.11153320E-01 0.11154731E-01 0.54400000E+00 0.33602763E-01 0.11203319E-01 0.11199013E-01 0.11200431E-01 0.54420000E+00 0.33740687E-01 0.11249303E-01 0.11244980E-01 0.11246404E-01 0.54440000E+00 0.33879440E-01 0.11295562E-01 0.11291223E-01 0.11292655E-01 0.54460000E+00 0.34019029E-01 0.11342101E-01 0.11337745E-01 0.11339183E-01 0.54480000E+00 0.34159462E-01 0.11388921E-01 0.11384548E-01 0.11385993E-01 0.54500000E+00 0.34300744E-01 0.11436024E-01 0.11431634E-01 0.11433087E-01 0.54520000E+00 0.34442884E-01 0.11483413E-01 0.11479006E-01 0.11480465E-01 0.54540000E+00 0.34585887E-01 0.11531089E-01 0.11526665E-01 0.11528132E-01 0.54560000E+00 0.34729761E-01 0.11579057E-01 0.11574615E-01 0.11576089E-01 0.54580000E+00 0.34874513E-01 0.11627316E-01 0.11622858E-01 0.11624339E-01 0.54600000E+00 0.35020151E-01 0.11675871E-01 0.11671395E-01 0.11672884E-01 0.54620000E+00 0.35166681E-01 0.11724724E-01 0.11720230E-01 0.11721726E-01 0.54640000E+00 0.35314111E-01 0.11773877E-01 0.11769365E-01 0.11770869E-01 0.54660000E+00 0.35462449E-01 0.11823332E-01 0.11818803E-01 0.11820314E-01 0.54680000E+00 0.35611701E-01 0.11873092E-01 0.11868545E-01 0.11870064E-01 0.54700000E+00 0.35761877E-01 0.11923160E-01 0.11918595E-01 0.11920121E-01 0.54720000E+00 0.35912983E-01 0.11973538E-01 0.11968956E-01 0.11970489E-01 0.54740000E+00 0.36065027E-01 0.12024229E-01 0.12019628E-01 0.12021169E-01 0.54760000E+00 0.36218017E-01 0.12075236E-01 0.12070616E-01 0.12072165E-01 0.54780000E+00 0.36371961E-01 0.12126560E-01 0.12121922E-01 0.12123479E-01 0.54800000E+00 0.36526867E-01 0.12178205E-01 0.12173549E-01 0.12175113E-01 0.54820000E+00 0.36682743E-01 0.12230174E-01 0.12225499E-01 0.12227071E-01 0.54840000E+00 0.36839598E-01 0.12282468E-01 0.12277775E-01 0.12279355E-01 0.54860000E+00 0.36997439E-01 0.12335092E-01 0.12330379E-01 0.12331967E-01 0.54880000E+00 0.37156275E-01 0.12388047E-01 0.12383316E-01 0.12384912E-01 0.54900000E+00 0.37316114E-01 0.12441337E-01 0.12436587E-01 0.12438191E-01 0.54920000E+00 0.37476966E-01 0.12494964E-01 0.12490195E-01 0.12491807E-01 0.54940000E+00 0.37638838E-01 0.12548932E-01 0.12544143E-01 0.12545763E-01 0.54960000E+00 0.37801740E-01 0.12603243E-01 0.12598434E-01 0.12600063E-01 0.54980000E+00 0.37965680E-01 0.12657900E-01 0.12653072E-01 0.12654709E-01 0.55000000E+00 0.38130668E-01 0.12712906E-01 0.12708058E-01 0.12709704E-01 0.55020000E+00 0.38296711E-01 0.12768264E-01 0.12763397E-01 0.12765051E-01 0.55040000E+00 0.38463820E-01 0.12823977E-01 0.12819090E-01 0.12820753E-01 0.55060000E+00 0.38632004E-01 0.12880049E-01 0.12875142E-01 0.12876813E-01 0.55080000E+00 0.38801271E-01 0.12936482E-01 0.12931555E-01 0.12933234E-01 0.55100000E+00 0.38971632E-01 0.12993279E-01 0.12988332E-01 0.12990020E-01 0.55120000E+00 0.39143096E-01 0.13050445E-01 0.13045477E-01 0.13047174E-01 0.55140000E+00 0.39315672E-01 0.13107981E-01 0.13102993E-01 0.13104699E-01 0.55160000E+00 0.39489371E-01 0.13165891E-01 0.13160883E-01 0.13162597E-01 0.55180000E+00 0.39664202E-01 0.13224179E-01 0.13219150E-01 0.13220873E-01 0.55200000E+00 0.39840175E-01 0.13282848E-01 0.13277797E-01 0.13279530E-01 0.55220000E+00 0.40017300E-01 0.13341901E-01 0.13336829E-01 0.13338571E-01 0.55240000E+00 0.40195588E-01 0.13401341E-01 0.13396248E-01 0.13397999E-01 0.55260000E+00 0.40375049E-01 0.13461172E-01 0.13456058E-01 0.13457818E-01 0.55280000E+00 0.40555692E-01 0.13521398E-01 0.13516263E-01 0.13518032E-01 0.55300000E+00 0.40737530E-01 0.13582022E-01 0.13576865E-01 0.13578643E-01 0.55320000E+00 0.40920571E-01 0.13643047E-01 0.13637868E-01 0.13639656E-01 0.55340000E+00 0.41104828E-01 0.13704477E-01 0.13699277E-01 0.13701074E-01 0.55360000E+00 0.41290311E-01 0.13766316E-01 0.13761094E-01 0.13762901E-01 0.55380000E+00 0.41477031E-01 0.13828568E-01 0.13823323E-01 0.13825140E-01 0.55400000E+00 0.41664999E-01 0.13891235E-01 0.13885969E-01 0.13887795E-01 0.55420000E+00 0.41854226E-01 0.13954323E-01 0.13949034E-01 0.13950870E-01 0.55440000E+00 0.42044725E-01 0.14017834E-01 0.14012522E-01 0.14014368E-01 0.55460000E+00 0.42236505E-01 0.14081773E-01 0.14076439E-01 0.14078294E-01 0.55480000E+00 0.42429580E-01 0.14146143E-01 0.14140786E-01 0.14142652E-01 0.55500000E+00 0.42623961E-01 0.14210948E-01 0.14205568E-01 0.14207444E-01 0.55520000E+00 0.42819659E-01 0.14276193E-01 0.14270790E-01 0.14272676E-01 0.55540000E+00 0.43016687E-01 0.14341881E-01 0.14336455E-01 0.14338351E-01 0.55560000E+00 0.43215058E-01 0.14408017E-01 0.14402567E-01 0.14404474E-01 0.55580000E+00 0.43414782E-01 0.14474604E-01 0.14469131E-01 0.14471048E-01 0.55600000E+00 0.43615874E-01 0.14541647E-01 0.14536150E-01 0.14538077E-01 0.55620000E+00 0.43818345E-01 0.14609149E-01 0.14603629E-01 0.14605567E-01 0.55640000E+00 0.44022209E-01 0.14677116E-01 0.14671572E-01 0.14673520E-01 0.55660000E+00 0.44227477E-01 0.14745552E-01 0.14739983E-01 0.14741942E-01 0.55680000E+00 0.44434164E-01 0.14814460E-01 0.14808867E-01 0.14810837E-01 0.55700000E+00 0.44642283E-01 0.14883846E-01 0.14878228E-01 0.14880209E-01 0.55720000E+00 0.44851847E-01 0.14953713E-01 0.14948071E-01 0.14950063E-01 0.55740000E+00 0.45062869E-01 0.15024067E-01 0.15018399E-01 0.15020403E-01 0.55760000E+00 0.45275363E-01 0.15094911E-01 0.15089219E-01 0.15091233E-01 0.55780000E+00 0.45489344E-01 0.15166251E-01 0.15160534E-01 0.15162559E-01 0.55800000E+00 0.45704824E-01 0.15238091E-01 0.15232348E-01 0.15234385E-01 0.55820000E+00 0.45921819E-01 0.15310436E-01 0.15304668E-01 0.15306716E-01 0.55840000E+00 0.46140343E-01 0.15383290E-01 0.15377497E-01 0.15379556E-01 0.55860000E+00 0.46360410E-01 0.15456659E-01 0.15450840E-01 0.15452911E-01 0.55880000E+00 0.46582035E-01 0.15530548E-01 0.15524702E-01 0.15526785E-01 0.55900000E+00 0.46805234E-01 0.15604961E-01 0.15599089E-01 0.15601184E-01 0.55920000E+00 0.47030020E-01 0.15679903E-01 0.15674005E-01 0.15676112E-01 0.55940000E+00 0.47256409E-01 0.15755380E-01 0.15749455E-01 0.15751574E-01 0.55960000E+00 0.47484417E-01 0.15831397E-01 0.15825445E-01 0.15827576E-01 0.55980000E+00 0.47714060E-01 0.15907958E-01 0.15901979E-01 0.15904122E-01 0.56000000E+00 0.47945352E-01 0.15985070E-01 0.15979064E-01 0.15981219E-01 0.56020000E+00 0.48178311E-01 0.16062737E-01 0.16056704E-01 0.16058871E-01 0.56040000E+00 0.48412953E-01 0.16140965E-01 0.16134904E-01 0.16137084E-01 0.56060000E+00 0.48649293E-01 0.16219759E-01 0.16213671E-01 0.16215863E-01 0.56080000E+00 0.48887348E-01 0.16299125E-01 0.16293009E-01 0.16295214E-01 0.56100000E+00 0.49127136E-01 0.16379069E-01 0.16372925E-01 0.16375143E-01 0.56120000E+00 0.49368674E-01 0.16459596E-01 0.16453423E-01 0.16455654E-01 0.56140000E+00 0.49611978E-01 0.16540712E-01 0.16534511E-01 0.16536755E-01 0.56160000E+00 0.49857065E-01 0.16622422E-01 0.16616193E-01 0.16618450E-01 0.56180000E+00 0.50103955E-01 0.16704734E-01 0.16698476E-01 0.16700746E-01 0.56200000E+00 0.50352664E-01 0.16787652E-01 0.16781364E-01 0.16783648E-01 0.56220000E+00 0.50603211E-01 0.16871183E-01 0.16864866E-01 0.16867163E-01 0.56240000E+00 0.50855614E-01 0.16955332E-01 0.16948986E-01 0.16951296E-01 0.56260000E+00 0.51109892E-01 0.17040106E-01 0.17033731E-01 0.17036055E-01 0.56280000E+00 0.51366063E-01 0.17125512E-01 0.17119106E-01 0.17121444E-01 0.56300000E+00 0.51624146E-01 0.17211555E-01 0.17205120E-01 0.17207471E-01 0.56320000E+00 0.51884161E-01 0.17298243E-01 0.17291777E-01 0.17294142E-01 0.56340000E+00 0.52146128E-01 0.17385581E-01 0.17379084E-01 0.17381464E-01 0.56360000E+00 0.52410066E-01 0.17473576E-01 0.17467048E-01 0.17469442E-01 0.56380000E+00 0.52675995E-01 0.17562234E-01 0.17555676E-01 0.17558084E-01 0.56400000E+00 0.52943935E-01 0.17651564E-01 0.17644974E-01 0.17647397E-01 0.56420000E+00 0.53213907E-01 0.17741571E-01 0.17734950E-01 0.17737387E-01 0.56440000E+00 0.53485932E-01 0.17832262E-01 0.17825609E-01 0.17828061E-01 0.56460000E+00 0.53760031E-01 0.17923645E-01 0.17916960E-01 0.17919427E-01 0.56480000E+00 0.54036225E-01 0.18015726E-01 0.18009009E-01 0.18011491E-01 0.56500000E+00 0.54314537E-01 0.18108513E-01 0.18101763E-01 0.18104261E-01 0.56520000E+00 0.54594986E-01 0.18202013E-01 0.18195231E-01 0.18197743E-01 0.56540000E+00 0.54877597E-01 0.18296233E-01 0.18289418E-01 0.18291946E-01 0.56560000E+00 0.55162392E-01 0.18391181E-01 0.18384334E-01 0.18386877E-01 0.56580000E+00 0.55449393E-01 0.18486865E-01 0.18479984E-01 0.18482543E-01 0.56600000E+00 0.55738623E-01 0.18583292E-01 0.18576378E-01 0.18578952E-01 0.56620000E+00 0.56030106E-01 0.18680471E-01 0.18673522E-01 0.18676113E-01 0.56640000E+00 0.56323865E-01 0.18778408E-01 0.18771425E-01 0.18774032E-01 0.56660000E+00 0.56619925E-01 0.18877112E-01 0.18870095E-01 0.18872718E-01 0.56680000E+00 0.56918309E-01 0.18976591E-01 0.18969540E-01 0.18972179E-01 0.56700000E+00 0.57219044E-01 0.19076854E-01 0.19069767E-01 0.19072423E-01 0.56720000E+00 0.57522152E-01 0.19177908E-01 0.19170786E-01 0.19173459E-01 0.56740000E+00 0.57827661E-01 0.19279762E-01 0.19272605E-01 0.19275294E-01 0.56760000E+00 0.58135595E-01 0.19382425E-01 0.19375232E-01 0.19377938E-01 0.56780000E+00 0.58445980E-01 0.19485905E-01 0.19478676E-01 0.19481399E-01 0.56800000E+00 0.58758844E-01 0.19590211E-01 0.19582946E-01 0.19585687E-01 0.56820000E+00 0.59074212E-01 0.19695352E-01 0.19688051E-01 0.19690809E-01 0.56840000E+00 0.59392111E-01 0.19801337E-01 0.19793999E-01 0.19796775E-01 0.56860000E+00 0.59712570E-01 0.19908176E-01 0.19900800E-01 0.19903594E-01 0.56880000E+00 0.60035615E-01 0.20015876E-01 0.20008464E-01 0.20011275E-01 0.56900000E+00 0.60361276E-01 0.20124449E-01 0.20116999E-01 0.20119828E-01 0.56920000E+00 0.60689580E-01 0.20233903E-01 0.20226415E-01 0.20229262E-01 0.56940000E+00 0.61020557E-01 0.20344248E-01 0.20336722E-01 0.20339588E-01 0.56960000E+00 0.61354237E-01 0.20455494E-01 0.20447929E-01 0.20450814E-01 0.56980000E+00 0.61690648E-01 0.20567651E-01 0.20560047E-01 0.20562950E-01 0.57000000E+00 0.62029821E-01 0.20680728E-01 0.20673085E-01 0.20676007E-01 0.57020000E+00 0.62371787E-01 0.20794737E-01 0.20787055E-01 0.20789996E-01 0.57040000E+00 0.62716577E-01 0.20909687E-01 0.20901965E-01 0.20904925E-01 0.57060000E+00 0.63064222E-01 0.21025589E-01 0.21017827E-01 0.21020806E-01 0.57080000E+00 0.63414754E-01 0.21142453E-01 0.21134651E-01 0.21137650E-01 0.57100000E+00 0.63768206E-01 0.21260291E-01 0.21252448E-01 0.21255467E-01 0.57120000E+00 0.64124610E-01 0.21379113E-01 0.21371229E-01 0.21374268E-01 0.57140000E+00 0.64484000E-01 0.21498931E-01 0.21491005E-01 0.21494064E-01 0.57160000E+00 0.64846409E-01 0.21619755E-01 0.21611787E-01 0.21614867E-01 0.57180000E+00 0.65211873E-01 0.21741597E-01 0.21733588E-01 0.21736688E-01 0.57200000E+00 0.65580424E-01 0.21864469E-01 0.21856417E-01 0.21859538E-01 0.57220000E+00 0.65952100E-01 0.21988382E-01 0.21980288E-01 0.21983430E-01 0.57240000E+00 0.66326935E-01 0.22113349E-01 0.22105211E-01 0.22108375E-01 0.57260000E+00 0.66704966E-01 0.22239381E-01 0.22231200E-01 0.22234385E-01 0.57280000E+00 0.67086229E-01 0.22366491E-01 0.22358266E-01 0.22361472E-01 0.57300000E+00 0.67470762E-01 0.22494691E-01 0.22486422E-01 0.22489650E-01 0.57320000E+00 0.67858603E-01 0.22623994E-01 0.22615680E-01 0.22618930E-01 0.57340000E+00 0.68249790E-01 0.22754412E-01 0.22746053E-01 0.22749325E-01 0.57360000E+00 0.68644362E-01 0.22885959E-01 0.22877555E-01 0.22880849E-01 0.57380000E+00 0.69042359E-01 0.23018647E-01 0.23010197E-01 0.23013515E-01 0.57400000E+00 0.69443821E-01 0.23152491E-01 0.23143995E-01 0.23147335E-01 0.57420000E+00 0.69848788E-01 0.23287503E-01 0.23278961E-01 0.23282324E-01 0.57440000E+00 0.70257303E-01 0.23423698E-01 0.23415109E-01 0.23418496E-01 0.57460000E+00 0.70669406E-01 0.23561089E-01 0.23552453E-01 0.23555863E-01 0.57480000E+00 0.71085140E-01 0.23699691E-01 0.23691007E-01 0.23694441E-01 0.57500000E+00 0.71504549E-01 0.23839518E-01 0.23830786E-01 0.23834244E-01 0.57520000E+00 0.71927676E-01 0.23980585E-01 0.23971804E-01 0.23975287E-01 0.57540000E+00 0.72354566E-01 0.24122906E-01 0.24114077E-01 0.24117584E-01 0.57560000E+00 0.72785265E-01 0.24266496E-01 0.24257618E-01 0.24261150E-01 0.57580000E+00 0.73219817E-01 0.24411372E-01 0.24402444E-01 0.24406001E-01 0.57600000E+00 0.73658269E-01 0.24557548E-01 0.24548570E-01 0.24552152E-01 0.57620000E+00 0.74100670E-01 0.24705040E-01 0.24696011E-01 0.24699619E-01 0.57640000E+00 0.74547066E-01 0.24853864E-01 0.24844784E-01 0.24848418E-01 0.57660000E+00 0.74997506E-01 0.25004036E-01 0.24994905E-01 0.24998565E-01 0.57680000E+00 0.75452040E-01 0.25155574E-01 0.25146390E-01 0.25150076E-01 0.57700000E+00 0.75910719E-01 0.25308492E-01 0.25299257E-01 0.25302969E-01 0.57720000E+00 0.76373592E-01 0.25462810E-01 0.25453521E-01 0.25457261E-01 0.57740000E+00 0.76840712E-01 0.25618543E-01 0.25609201E-01 0.25612968E-01 0.57760000E+00 0.77312132E-01 0.25775709E-01 0.25766314E-01 0.25770108E-01 0.57780000E+00 0.77787904E-01 0.25934327E-01 0.25924878E-01 0.25928699E-01 0.57800000E+00 0.78268084E-01 0.26094414E-01 0.26084910E-01 0.26088760E-01 0.57820000E+00 0.78752725E-01 0.26255989E-01 0.26246429E-01 0.26250307E-01 0.57840000E+00 0.79241885E-01 0.26419069E-01 0.26409454E-01 0.26413361E-01 0.57860000E+00 0.79735619E-01 0.26583676E-01 0.26574004E-01 0.26577940E-01 0.57880000E+00 0.80233986E-01 0.26749826E-01 0.26740098E-01 0.26744063E-01 0.57900000E+00 0.80737045E-01 0.26917540E-01 0.26907755E-01 0.26911749E-01 0.57920000E+00 0.81244854E-01 0.27086839E-01 0.27076996E-01 0.27081020E-01 0.57940000E+00 0.81757475E-01 0.27257741E-01 0.27247840E-01 0.27251894E-01 0.57960000E+00 0.82274968E-01 0.27430268E-01 0.27420308E-01 0.27424393E-01 0.57980000E+00 0.82797397E-01 0.27604440E-01 0.27594421E-01 0.27598536E-01 0.58000000E+00 0.83324825E-01 0.27780279E-01 0.27770199E-01 0.27774346E-01 0.58020000E+00 0.83857316E-01 0.27957806E-01 0.27947666E-01 0.27951844E-01 0.58040000E+00 0.84394936E-01 0.28137042E-01 0.28126841E-01 0.28131052E-01 0.58060000E+00 0.84937751E-01 0.28318011E-01 0.28307749E-01 0.28311991E-01 0.58080000E+00 0.85485830E-01 0.28500735E-01 0.28490410E-01 0.28494685E-01 0.58100000E+00 0.86039241E-01 0.28685236E-01 0.28674848E-01 0.28679157E-01 0.58120000E+00 0.86598054E-01 0.28871538E-01 0.28861087E-01 0.28865429E-01 0.58140000E+00 0.87162341E-01 0.29059665E-01 0.29049150E-01 0.29053525E-01 0.58160000E+00 0.87732172E-01 0.29249641E-01 0.29239061E-01 0.29243470E-01 0.58180000E+00 0.88307623E-01 0.29441490E-01 0.29430845E-01 0.29435289E-01 0.58200000E+00 0.88888767E-01 0.29635237E-01 0.29624526E-01 0.29629005E-01 0.58220000E+00 0.89475682E-01 0.29830907E-01 0.29820130E-01 0.29824644E-01 0.58240000E+00 0.90068443E-01 0.30028527E-01 0.30017683E-01 0.30022232E-01 0.58260000E+00 0.90667129E-01 0.30228122E-01 0.30217211E-01 0.30221796E-01 0.58280000E+00 0.91271821E-01 0.30429720E-01 0.30418740E-01 0.30423361E-01 0.58300000E+00 0.91882599E-01 0.30633346E-01 0.30622297E-01 0.30626956E-01 0.58320000E+00 0.92499546E-01 0.30839029E-01 0.30827910E-01 0.30832606E-01 0.58340000E+00 0.93122747E-01 0.31046797E-01 0.31035608E-01 0.31040341E-01 0.58360000E+00 0.93752286E-01 0.31256678E-01 0.31245418E-01 0.31250190E-01 0.58380000E+00 0.94388250E-01 0.31468702E-01 0.31457369E-01 0.31462179E-01 0.58400000E+00 0.95030728E-01 0.31682896E-01 0.31671491E-01 0.31676341E-01 0.58420000E+00 0.95679810E-01 0.31899293E-01 0.31887815E-01 0.31892703E-01 0.58440000E+00 0.96335588E-01 0.32117921E-01 0.32106369E-01 0.32111298E-01 0.58460000E+00 0.96998153E-01 0.32338813E-01 0.32327186E-01 0.32332155E-01 0.58480000E+00 0.97667602E-01 0.32561999E-01 0.32550297E-01 0.32555307E-01 0.58500000E+00 0.98344030E-01 0.32787512E-01 0.32775733E-01 0.32780785E-01 0.58520000E+00 0.99027536E-01 0.33015385E-01 0.33003529E-01 0.33008622E-01 0.58540000E+00 0.99718219E-01 0.33245650E-01 0.33233717E-01 0.33238852E-01 0.58560000E+00 0.10041618E+00 0.33478342E-01 0.33466330E-01 0.33471508E-01 0.58580000E+00 0.10112152E+00 0.33713495E-01 0.33701404E-01 0.33706626E-01 0.58600000E+00 0.10183436E+00 0.33951144E-01 0.33938973E-01 0.33944238E-01 0.58620000E+00 0.10255478E+00 0.34191325E-01 0.34179073E-01 0.34184383E-01 0.58640000E+00 0.10328291E+00 0.34434075E-01 0.34421740E-01 0.34427095E-01 0.58660000E+00 0.10401885E+00 0.34679429E-01 0.34667012E-01 0.34672413E-01 0.58680000E+00 0.10476272E+00 0.34927426E-01 0.34914926E-01 0.34920372E-01 0.58700000E+00 0.10551464E+00 0.35178105E-01 0.35165520E-01 0.35171013E-01 0.58720000E+00 0.10627471E+00 0.35431504E-01 0.35418833E-01 0.35424374E-01 0.58740000E+00 0.10704306E+00 0.35687663E-01 0.35674906E-01 0.35680494E-01 0.58760000E+00 0.10781981E+00 0.35946622E-01 0.35933778E-01 0.35939415E-01 0.58780000E+00 0.10860509E+00 0.36208423E-01 0.36195491E-01 0.36201177E-01 0.58800000E+00 0.10939902E+00 0.36473108E-01 0.36460086E-01 0.36465822E-01 0.58820000E+00 0.11020172E+00 0.36740719E-01 0.36727608E-01 0.36733394E-01 0.58840000E+00 0.11101333E+00 0.37011300E-01 0.36998098E-01 0.37003935E-01 0.58860000E+00 0.11183399E+00 0.37284896E-01 0.37271602E-01 0.37277491E-01 0.58880000E+00 0.11266382E+00 0.37561552E-01 0.37548165E-01 0.37554105E-01 0.58900000E+00 0.11350297E+00 0.37841313E-01 0.37827832E-01 0.37833826E-01 0.58920000E+00 0.11435158E+00 0.38124227E-01 0.38110651E-01 0.38116698E-01 0.58940000E+00 0.11520978E+00 0.38410342E-01 0.38396669E-01 0.38402771E-01 0.58960000E+00 0.11607773E+00 0.38699705E-01 0.38685936E-01 0.38692093E-01 0.58980000E+00 0.11695558E+00 0.38992368E-01 0.38978501E-01 0.38984713E-01 0.59000000E+00 0.11784348E+00 0.39288381E-01 0.39274414E-01 0.39280682E-01 0.59020000E+00 0.11874157E+00 0.39587794E-01 0.39573727E-01 0.39580053E-01 0.59040000E+00 0.11965003E+00 0.39890661E-01 0.39876492E-01 0.39882876E-01 0.59060000E+00 0.12056901E+00 0.40197036E-01 0.40182764E-01 0.40189207E-01 0.59080000E+00 0.12149867E+00 0.40506973E-01 0.40492597E-01 0.40499099E-01 0.59100000E+00 0.12243918E+00 0.40820527E-01 0.40806047E-01 0.40812609E-01 0.59120000E+00 0.12339072E+00 0.41137756E-01 0.41123170E-01 0.41129793E-01 0.59140000E+00 0.12435345E+00 0.41458718E-01 0.41444024E-01 0.41450709E-01 0.59160000E+00 0.12532756E+00 0.41783471E-01 0.41768668E-01 0.41775416E-01 0.59180000E+00 0.12631321E+00 0.42112076E-01 0.42097163E-01 0.42103975E-01 0.59200000E+00 0.12731061E+00 0.42444594E-01 0.42429571E-01 0.42436447E-01 0.59220000E+00 0.12831994E+00 0.42781089E-01 0.42765953E-01 0.42772894E-01 0.59240000E+00 0.12934138E+00 0.43121623E-01 0.43106373E-01 0.43113381E-01 0.59260000E+00 0.13037513E+00 0.43466263E-01 0.43450898E-01 0.43457972E-01 0.59280000E+00 0.13142140E+00 0.43815075E-01 0.43799593E-01 0.43806735E-01 0.59300000E+00 0.13248039E+00 0.44168126E-01 0.44152526E-01 0.44159738E-01 0.59320000E+00 0.13355230E+00 0.44525486E-01 0.44509767E-01 0.44517049E-01 0.59340000E+00 0.13463735E+00 0.44887226E-01 0.44871386E-01 0.44878739E-01 0.59360000E+00 0.13573575E+00 0.45253418E-01 0.45237456E-01 0.45244881E-01 0.59380000E+00 0.13684773E+00 0.45624135E-01 0.45608050E-01 0.45615547E-01 0.59400000E+00 0.13797351E+00 0.45999453E-01 0.45983243E-01 0.45990814E-01 0.59420000E+00 0.13911332E+00 0.46379449E-01 0.46363112E-01 0.46370759E-01 0.59440000E+00 0.14026739E+00 0.46764201E-01 0.46747736E-01 0.46755458E-01 0.59460000E+00 0.14143597E+00 0.47153788E-01 0.47137193E-01 0.47144993E-01 0.59480000E+00 0.14261931E+00 0.47548293E-01 0.47531567E-01 0.47539445E-01 0.59500000E+00 0.14381764E+00 0.47947799E-01 0.47930940E-01 0.47938898E-01 0.59520000E+00 0.14503123E+00 0.48352392E-01 0.48335398E-01 0.48343436E-01 0.59540000E+00 0.14626033E+00 0.48762158E-01 0.48745027E-01 0.48753148E-01 0.59560000E+00 0.14750522E+00 0.49177185E-01 0.49159917E-01 0.49168120E-01 0.59580000E+00 0.14876617E+00 0.49597566E-01 0.49580158E-01 0.49588446E-01 0.59600000E+00 0.15004345E+00 0.50023392E-01 0.50005843E-01 0.50014216E-01 0.59620000E+00 0.15133735E+00 0.50454759E-01 0.50437067E-01 0.50445526E-01 0.59640000E+00 0.15264816E+00 0.50891764E-01 0.50873926E-01 0.50882474E-01 0.59660000E+00 0.15397618E+00 0.51334504E-01 0.51316519E-01 0.51325157E-01 0.59680000E+00 0.15532171E+00 0.51783082E-01 0.51764948E-01 0.51773676E-01 0.59700000E+00 0.15668505E+00 0.52237601E-01 0.52219316E-01 0.52228137E-01 0.59720000E+00 0.15806654E+00 0.52698166E-01 0.52679729E-01 0.52688643E-01 0.59740000E+00 0.15946648E+00 0.53164886E-01 0.53146294E-01 0.53155302E-01 0.59760000E+00 0.16088522E+00 0.53637870E-01 0.53619121E-01 0.53628227E-01 0.59780000E+00 0.16232309E+00 0.54117233E-01 0.54098325E-01 0.54107528E-01 0.59800000E+00 0.16378043E+00 0.54603088E-01 0.54584020E-01 0.54593322E-01 0.59820000E+00 0.16525761E+00 0.55095555E-01 0.55076324E-01 0.55085727E-01 0.59840000E+00 0.16675498E+00 0.55594755E-01 0.55575358E-01 0.55584864E-01 0.59860000E+00 0.16827291E+00 0.56100810E-01 0.56081245E-01 0.56090856E-01 0.59880000E+00 0.16981179E+00 0.56613847E-01 0.56594112E-01 0.56603829E-01 0.59900000E+00 0.17137200E+00 0.57133995E-01 0.57114089E-01 0.57123913E-01 0.59920000E+00 0.17295393E+00 0.57661387E-01 0.57641306E-01 0.57651240E-01 0.59940000E+00 0.17455800E+00 0.58196158E-01 0.58175900E-01 0.58185945E-01 0.59960000E+00 0.17618462E+00 0.58738446E-01 0.58718009E-01 0.58728167E-01 0.59980000E+00 0.17783422E+00 0.59288394E-01 0.59267775E-01 0.59278048E-01 0.60000000E+00 0.17950722E+00 0.59846146E-01 0.59825343E-01 0.59835732E-01 0.60020000E+00 0.18120408E+00 0.60411852E-01 0.60390862E-01 0.60401369E-01 0.60040000E+00 0.18292526E+00 0.60985662E-01 0.60964483E-01 0.60975110E-01 0.60060000E+00 0.18467121E+00 0.61567733E-01 0.61546362E-01 0.61557112E-01 0.60080000E+00 0.18644242E+00 0.62158225E-01 0.62136659E-01 0.62147533E-01 0.60100000E+00 0.18823937E+00 0.62757300E-01 0.62735536E-01 0.62746538E-01 0.60120000E+00 0.19006258E+00 0.63365126E-01 0.63343162E-01 0.63354292E-01 0.60140000E+00 0.19191255E+00 0.63981875E-01 0.63959708E-01 0.63970969E-01 0.60160000E+00 0.19378981E+00 0.64607722E-01 0.64585349E-01 0.64596743E-01 0.60180000E+00 0.19569490E+00 0.65242847E-01 0.65220264E-01 0.65231794E-01 0.60200000E+00 0.19762838E+00 0.65887434E-01 0.65864639E-01 0.65876306E-01 0.60220000E+00 0.19959080E+00 0.66541673E-01 0.66518662E-01 0.66530469E-01 0.60240000E+00 0.20158276E+00 0.67205756E-01 0.67182527E-01 0.67194477E-01 0.60260000E+00 0.20360484E+00 0.67879883E-01 0.67856432E-01 0.67868527E-01 0.60280000E+00 0.20565766E+00 0.68564257E-01 0.68540581E-01 0.68552823E-01 0.60300000E+00 0.20774184E+00 0.69259086E-01 0.69235182E-01 0.69247574E-01 0.60320000E+00 0.20985803E+00 0.69964586E-01 0.69940449E-01 0.69952994E-01 0.60340000E+00 0.21200688E+00 0.70680974E-01 0.70656602E-01 0.70669303E-01 0.60360000E+00 0.21418907E+00 0.71408477E-01 0.71383866E-01 0.71396725E-01 0.60380000E+00 0.21640529E+00 0.72147325E-01 0.72122471E-01 0.72135492E-01 0.60400000E+00 0.21865625E+00 0.72897755E-01 0.72872655E-01 0.72885840E-01 0.60420000E+00 0.22094268E+00 0.73660011E-01 0.73634661E-01 0.73648012E-01 0.60440000E+00 0.22326534E+00 0.74434341E-01 0.74408737E-01 0.74422259E-01 0.60460000E+00 0.22562498E+00 0.75221003E-01 0.75195140E-01 0.75208835E-01 0.60480000E+00 0.22802240E+00 0.76020258E-01 0.75994133E-01 0.76008005E-01 0.60500000E+00 0.23045840E+00 0.76832377E-01 0.76805986E-01 0.76820037E-01 0.60520000E+00 0.23293382E+00 0.77657636E-01 0.77630975E-01 0.77645209E-01 0.60540000E+00 0.23544951E+00 0.78496321E-01 0.78469385E-01 0.78483806E-01 0.60560000E+00 0.23800635E+00 0.79348724E-01 0.79321508E-01 0.79336120E-01 0.60580000E+00 0.24060524E+00 0.80215144E-01 0.80187645E-01 0.80202450E-01 0.60600000E+00 0.24324710E+00 0.81095891E-01 0.81068103E-01 0.81083106E-01 0.60620000E+00 0.24593288E+00 0.81991280E-01 0.81963199E-01 0.81978403E-01 0.60640000E+00 0.24866357E+00 0.82901638E-01 0.82873260E-01 0.82888669E-01 0.60660000E+00 0.25144016E+00 0.83827300E-01 0.83798618E-01 0.83814237E-01 0.60680000E+00 0.25426368E+00 0.84768609E-01 0.84739620E-01 0.84755452E-01 0.60700000E+00 0.25713520E+00 0.85725919E-01 0.85696617E-01 0.85712666E-01 0.60720000E+00 0.26005581E+00 0.86699594E-01 0.86669973E-01 0.86686245E-01 0.60740000E+00 0.26302663E+00 0.87690008E-01 0.87660063E-01 0.87676561E-01 0.60760000E+00 0.26604881E+00 0.88697544E-01 0.88667271E-01 0.88683999E-01 0.60780000E+00 0.26912355E+00 0.89722600E-01 0.89691992E-01 0.89708956E-01 0.60800000E+00 0.27225205E+00 0.90765582E-01 0.90734633E-01 0.90751838E-01 0.60820000E+00 0.27543559E+00 0.91826909E-01 0.91795614E-01 0.91813063E-01 0.60840000E+00 0.27867544E+00 0.92907012E-01 0.92875365E-01 0.92893064E-01 0.60860000E+00 0.28197295E+00 0.94006335E-01 0.93974329E-01 0.93992284E-01 0.60880000E+00 0.28532948E+00 0.95125335E-01 0.95092963E-01 0.95111179E-01 0.60900000E+00 0.28874644E+00 0.96264481E-01 0.96231738E-01 0.96250220E-01 0.60920000E+00 0.29222529E+00 0.97424259E-01 0.97391138E-01 0.97409892E-01 0.60940000E+00 0.29576752E+00 0.98605167E-01 0.98571661E-01 0.98590693E-01 0.60960000E+00 0.29937468E+00 0.99807719E-01 0.99773822E-01 0.99793137E-01 0.60980000E+00 0.30304835E+00 0.10103245E+00 0.10099815E+00 0.10101775E+00 0.61000000E+00 0.30679017E+00 0.10227989E+00 0.10224519E+00 0.10226509E+00 0.61020000E+00 0.31060183E+00 0.10355062E+00 0.10351550E+00 0.10353570E+00 0.61040000E+00 0.31448506E+00 0.10484521E+00 0.10480967E+00 0.10483018E+00 0.61060000E+00 0.31844166E+00 0.10616426E+00 0.10612829E+00 0.10614912E+00 0.61080000E+00 0.32247348E+00 0.10750838E+00 0.10747198E+00 0.10749313E+00 0.61100000E+00 0.32658243E+00 0.10887822E+00 0.10884137E+00 0.10886285E+00 0.61120000E+00 0.33077047E+00 0.11027442E+00 0.11023712E+00 0.11025893E+00 0.61140000E+00 0.33503964E+00 0.11169767E+00 0.11165990E+00 0.11168206E+00 0.61160000E+00 0.33939202E+00 0.11314866E+00 0.11311042E+00 0.11313294E+00 0.61180000E+00 0.34382978E+00 0.11462811E+00 0.11458940E+00 0.11461227E+00 0.61200000E+00 0.34835516E+00 0.11613678E+00 0.11609757E+00 0.11612081E+00 0.61220000E+00 0.35297045E+00 0.11767541E+00 0.11763571E+00 0.11765933E+00 0.61240000E+00 0.35767804E+00 0.11924482E+00 0.11920460E+00 0.11922861E+00 0.61260000E+00 0.36248039E+00 0.12084582E+00 0.12080508E+00 0.12082949E+00 0.61280000E+00 0.36738003E+00 0.12247925E+00 0.12243798E+00 0.12246279E+00 0.61300000E+00 0.37237960E+00 0.12414599E+00 0.12410419E+00 0.12412941E+00 0.61320000E+00 0.37748180E+00 0.12584695E+00 0.12580460E+00 0.12583025E+00 0.61340000E+00 0.38268944E+00 0.12758306E+00 0.12754014E+00 0.12756623E+00 0.61360000E+00 0.38800542E+00 0.12935529E+00 0.12931180E+00 0.12933833E+00 0.61380000E+00 0.39343274E+00 0.13116464E+00 0.13112056E+00 0.13114754E+00 0.61400000E+00 0.39897450E+00 0.13301213E+00 0.13296746E+00 0.13299491E+00 0.61420000E+00 0.40463391E+00 0.13489885E+00 0.13485356E+00 0.13488150E+00 0.61440000E+00 0.41041430E+00 0.13682590E+00 0.13677999E+00 0.13680841E+00 0.61460000E+00 0.41631910E+00 0.13879442E+00 0.13874787E+00 0.13877680E+00 0.61480000E+00 0.42235187E+00 0.14080561E+00 0.14075841E+00 0.14078785E+00 0.61500000E+00 0.42851630E+00 0.14286069E+00 0.14281282E+00 0.14284280E+00 0.61520000E+00 0.43481621E+00 0.14496093E+00 0.14491238E+00 0.14494290E+00 0.61540000E+00 0.44125556E+00 0.14710765E+00 0.14705841E+00 0.14708949E+00 0.61560000E+00 0.44783843E+00 0.14930223E+00 0.14925228E+00 0.14928393E+00 0.61580000E+00 0.45456909E+00 0.15154607E+00 0.15149539E+00 0.15152763E+00 0.61600000E+00 0.46145194E+00 0.15384064E+00 0.15378923E+00 0.15382207E+00 0.61620000E+00 0.46849154E+00 0.15618747E+00 0.15613530E+00 0.15616876E+00 0.61640000E+00 0.47569263E+00 0.15858814E+00 0.15853520E+00 0.15856929E+00 0.61660000E+00 0.48306013E+00 0.16104429E+00 0.16099055E+00 0.16102530E+00 0.61680000E+00 0.49059915E+00 0.16355761E+00 0.16350306E+00 0.16353848E+00 0.61700000E+00 0.49831497E+00 0.16612987E+00 0.16607450E+00 0.16611060E+00 0.61720000E+00 0.50621310E+00 0.16876291E+00 0.16870668E+00 0.16874350E+00 0.61740000E+00 0.51429923E+00 0.17145863E+00 0.17140153E+00 0.17143907E+00 0.61760000E+00 0.52257932E+00 0.17421900E+00 0.17416101E+00 0.17419931E+00 0.61780000E+00 0.53105951E+00 0.17704608E+00 0.17698718E+00 0.17702625E+00 0.61800000E+00 0.53974621E+00 0.17994201E+00 0.17988218E+00 0.17992203E+00 0.61820000E+00 0.54864609E+00 0.18290900E+00 0.18284821E+00 0.18288888E+00 0.61840000E+00 0.55776607E+00 0.18594936E+00 0.18588760E+00 0.18592911E+00 0.61860000E+00 0.56711334E+00 0.18906550E+00 0.18900273E+00 0.18904511E+00 0.61880000E+00 0.57669541E+00 0.19225991E+00 0.19219612E+00 0.19223938E+00 0.61900000E+00 0.58652008E+00 0.19553520E+00 0.19547035E+00 0.19551453E+00 0.61920000E+00 0.59659546E+00 0.19889406E+00 0.19882814E+00 0.19887326E+00 0.61940000E+00 0.60693001E+00 0.20233933E+00 0.20227229E+00 0.20231839E+00 0.61960000E+00 0.61753254E+00 0.20587393E+00 0.20580576E+00 0.20585285E+00 0.61980000E+00 0.62841223E+00 0.20950093E+00 0.20943159E+00 0.20947972E+00 0.62000000E+00 0.63957865E+00 0.21322351E+00 0.21315297E+00 0.21320217E+00 0.62020000E+00 0.65104176E+00 0.21704499E+00 0.21697324E+00 0.21702353E+00 0.62040000E+00 0.66281196E+00 0.22096886E+00 0.22089584E+00 0.22094727E+00 0.62060000E+00 0.67490012E+00 0.22499872E+00 0.22492440E+00 0.22497700E+00 0.62080000E+00 0.68731754E+00 0.22913834E+00 0.22906270E+00 0.22911650E+00 0.62100000E+00 0.70007605E+00 0.23339167E+00 0.23331467E+00 0.23336971E+00 0.62120000E+00 0.71318799E+00 0.23776282E+00 0.23768442E+00 0.23774075E+00 0.62140000E+00 0.72666624E+00 0.24225609E+00 0.24217624E+00 0.24223391E+00 0.62160000E+00 0.74052429E+00 0.24687597E+00 0.24679464E+00 0.24685368E+00 0.62180000E+00 0.75477619E+00 0.25162714E+00 0.25154429E+00 0.25160475E+00 0.62200000E+00 0.76943667E+00 0.25651453E+00 0.25643011E+00 0.25649203E+00 0.62220000E+00 0.78452112E+00 0.26154324E+00 0.26145722E+00 0.26152066E+00 0.62240000E+00 0.80004564E+00 0.26671867E+00 0.26663098E+00 0.26669600E+00 0.62260000E+00 0.81602709E+00 0.27204641E+00 0.27195702E+00 0.27202366E+00 0.62280000E+00 0.83248311E+00 0.27753236E+00 0.27744121E+00 0.27750954E+00 0.62300000E+00 0.84943218E+00 0.28318267E+00 0.28308972E+00 0.28315979E+00 0.62320000E+00 0.86689364E+00 0.28900380E+00 0.28890899E+00 0.28898086E+00 0.62340000E+00 0.88488780E+00 0.29500251E+00 0.29490578E+00 0.29497952E+00 0.62360000E+00 0.90343592E+00 0.30118588E+00 0.30108718E+00 0.30116286E+00 0.62380000E+00 0.92256029E+00 0.30756136E+00 0.30746062E+00 0.30753831E+00 0.62400000E+00 0.94228432E+00 0.31413675E+00 0.31403390E+00 0.31411368E+00 0.62420000E+00 0.96263257E+00 0.32092022E+00 0.32081521E+00 0.32089714E+00 0.62440000E+00 0.98363082E+00 0.32792038E+00 0.32781313E+00 0.32789731E+00 0.62460000E+00 0.10053061E+01 0.33514624E+00 0.33503669E+00 0.33512320E+00 0.62480000E+00 0.10276870E+01 0.34260730E+00 0.34249536E+00 0.34258429E+00 0.62500000E+00 0.10508032E+01 0.35031351E+00 0.35019912E+00 0.35029056E+00 0.62520000E+00 0.10746863E+01 0.35827535E+00 0.35815842E+00 0.35825248E+00 0.62540000E+00 0.10993692E+01 0.36650385E+00 0.36638430E+00 0.36648107E+00 0.62560000E+00 0.11248868E+01 0.37501059E+00 0.37488833E+00 0.37498792E+00 0.62580000E+00 0.11512757E+01 0.38380778E+00 0.38368271E+00 0.38378525E+00 0.62600000E+00 0.11785744E+01 0.39290826E+00 0.39278029E+00 0.39288589E+00 0.62620000E+00 0.12068236E+01 0.40232557E+00 0.40219460E+00 0.40230338E+00 0.62640000E+00 0.12360658E+01 0.41207395E+00 0.41193989E+00 0.41205198E+00 0.62660000E+00 0.12663463E+01 0.42216845E+00 0.42203117E+00 0.42214672E+00 0.62680000E+00 0.12977126E+01 0.43262489E+00 0.43248428E+00 0.43260344E+00 0.62700000E+00 0.13302148E+01 0.44345999E+00 0.44331594E+00 0.44343885E+00 0.62720000E+00 0.13639057E+01 0.45469138E+00 0.45454375E+00 0.45467059E+00 0.62740000E+00 0.13988413E+01 0.46633766E+00 0.46618634E+00 0.46631726E+00 0.62760000E+00 0.14350803E+01 0.47841849E+00 0.47826332E+00 0.47839852E+00 0.62780000E+00 0.14726852E+01 0.49095460E+00 0.49079545E+00 0.49093511E+00 0.62800000E+00 0.15117215E+01 0.50396791E+00 0.50380463E+00 0.50394895E+00 0.62820000E+00 0.15522588E+01 0.51748160E+00 0.51731402E+00 0.51746321E+00 0.62840000E+00 0.15943706E+01 0.53152012E+00 0.53134810E+00 0.53150238E+00 0.62860000E+00 0.16381344E+01 0.54610938E+00 0.54593273E+00 0.54609233E+00 0.62880000E+00 0.16836325E+01 0.56127675E+00 0.56109528E+00 0.56126046E+00 0.62900000E+00 0.17309516E+01 0.57705118E+00 0.57686471E+00 0.57703573E+00 0.62920000E+00 0.17801837E+01 0.59346331E+00 0.59327163E+00 0.59344876E+00 0.62940000E+00 0.18314260E+01 0.61054556E+00 0.61034847E+00 0.61053200E+00 0.62960000E+00 0.18847815E+01 0.62833224E+00 0.62812952E+00 0.62831976E+00 0.62980000E+00 0.19403591E+01 0.64685967E+00 0.64665108E+00 0.64684836E+00 0.63000000E+00 0.19982741E+01 0.66616629E+00 0.66595159E+00 0.66615625E+00 0.63020000E+00 0.20586487E+01 0.68629280E+00 0.68607173E+00 0.68628414E+00 0.63040000E+00 0.21216119E+01 0.70728228E+00 0.70705457E+00 0.70727510E+00 0.63060000E+00 0.21873008E+01 0.72918032E+00 0.72894568E+00 0.72917475E+00 0.63080000E+00 0.22558598E+01 0.75203518E+00 0.75179331E+00 0.75203134E+00 0.63100000E+00 0.23274424E+01 0.77589791E+00 0.77564851E+00 0.77589595E+00 0.63120000E+00 0.24022104E+01 0.80082253E+00 0.80056525E+00 0.80082258E+00 0.63140000E+00 0.24803351E+01 0.82686614E+00 0.82660063E+00 0.82686836E+00 0.63160000E+00 0.25619977E+01 0.85408909E+00 0.85381498E+00 0.85409365E+00 0.63180000E+00 0.26473893E+01 0.88255513E+00 0.88227203E+00 0.88256219E+00 0.63200000E+00 0.27367118E+01 0.91233152E+00 0.91203902E+00 0.91234127E+00 0.63220000E+00 0.28301779E+01 0.94348921E+00 0.94318687E+00 0.94350184E+00 0.63240000E+00 0.29280118E+01 0.97610290E+00 0.97579027E+00 0.97611862E+00 0.63260000E+00 0.30304492E+01 0.10102512E+01 0.10099278E+01 0.10102702E+01 0.63280000E+00 0.31377377E+01 0.10460166E+01 0.10456819E+01 0.10460391E+01 0.63300000E+00 0.32501369E+01 0.10834857E+01 0.10831392E+01 0.10835120E+01 0.63320000E+00 0.33679183E+01 0.11227490E+01 0.11223901E+01 0.11227792E+01 0.63340000E+00 0.34913653E+01 0.11639009E+01 0.11635290E+01 0.11639354E+01 0.63360000E+00 0.36207725E+01 0.12070396E+01 0.12066542E+01 0.12070786E+01 0.63380000E+00 0.37564453E+01 0.12522671E+01 0.12518674E+01 0.12523108E+01 0.63400000E+00 0.38986989E+01 0.12996883E+01 0.12992737E+01 0.12997369E+01 0.63420000E+00 0.40478569E+01 0.13494111E+01 0.13489808E+01 0.13494650E+01 0.63440000E+00 0.42042495E+01 0.14015457E+01 0.14010989E+01 0.14016050E+01 0.63460000E+00 0.43682111E+01 0.14562033E+01 0.14557394E+01 0.14562683E+01 0.63480000E+00 0.45400769E+01 0.15134960E+01 0.15130140E+01 0.15135668E+01 0.63500000E+00 0.47201795E+01 0.15735345E+01 0.15730336E+01 0.15736114E+01 0.63520000E+00 0.49088439E+01 0.16364272E+01 0.16359065E+01 0.16365102E+01 0.63540000E+00 0.51063811E+01 0.17022778E+01 0.17017363E+01 0.17023670E+01 0.63560000E+00 0.53130816E+01 0.17711832E+01 0.17706199E+01 0.17712785E+01 0.63580000E+00 0.55292060E+01 0.18432302E+01 0.18426442E+01 0.18433316E+01 0.63600000E+00 0.57549749E+01 0.19184925E+01 0.19178827E+01 0.19185997E+01 0.63620000E+00 0.59905569E+01 0.19970263E+01 0.19963917E+01 0.19971389E+01 0.63640000E+00 0.62360539E+01 0.20788656E+01 0.20782051E+01 0.20789832E+01 0.63660000E+00 0.64914851E+01 0.21640169E+01 0.21633295E+01 0.21641387E+01 0.63680000E+00 0.67567680E+01 0.22524529E+01 0.22517373E+01 0.22525778E+01 0.63700000E+00 0.70316980E+01 0.23441052E+01 0.23433606E+01 0.23442322E+01 0.63720000E+00 0.73159248E+01 0.24388574E+01 0.24380826E+01 0.24389848E+01 0.63740000E+00 0.76089277E+01 0.25365359E+01 0.25357300E+01 0.25366619E+01 0.63760000E+00 0.79099895E+01 0.26369017E+01 0.26360638E+01 0.26370239E+01 0.63780000E+00 0.82181690E+01 0.27396414E+01 0.27387706E+01 0.27397570E+01 0.63800000E+00 0.85322748E+01 0.28443578E+01 0.28434534E+01 0.28444636E+01 0.63820000E+00 0.88508407E+01 0.29505623E+01 0.29496237E+01 0.29506546E+01 0.63840000E+00 0.91721037E+01 0.30576675E+01 0.30566943E+01 0.30577419E+01 0.63860000E+00 0.94939894E+01 0.31649819E+01 0.31639739E+01 0.31650336E+01 0.63880000E+00 0.98141042E+01 0.32717078E+01 0.32706650E+01 0.32717313E+01 0.63900000E+00 0.10129739E+02 0.33769423E+01 0.33758650E+01 0.33769318E+01 0.63920000E+00 0.10437887E+02 0.34796831E+01 0.34785718E+01 0.34796323E+01 0.63940000E+00 0.10735277E+02 0.35788395E+01 0.35776953E+01 0.35787419E+01 0.63960000E+00 0.11018423E+02 0.36732500E+01 0.36720742E+01 0.36730988E+01 0.63980000E+00 0.11283698E+02 0.37617051E+01 0.37604993E+01 0.37614936E+01 0.64000000E+00 0.11527420E+02 0.38429774E+01 0.38417437E+01 0.38426991E+01 0.64020000E+00 0.11745959E+02 0.39158565E+01 0.39145975E+01 0.39155055E+01 0.64040000E+00 0.11935855E+02 0.39791886E+01 0.39779071E+01 0.39787596E+01 0.64060000E+00 0.12093942E+02 0.40319179E+01 0.40306171E+01 0.40314065E+01 0.64080000E+00 0.12217470E+02 0.40731278E+01 0.40718113E+01 0.40725311E+01 0.64100000E+00 0.12304227E+02 0.41020798E+01 0.41007514E+01 0.41013960E+01 0.64120000E+00 0.12352629E+02 0.41182453E+01 0.41169092E+01 0.41174745E+01 0.64140000E+00 0.12361795E+02 0.41213305E+01 0.41199908E+01 0.41204741E+01 0.64160000E+00 0.12331591E+02 0.41112895E+01 0.41099504E+01 0.41103507E+01 0.64180000E+00 0.12262628E+02 0.40883262E+01 0.40869921E+01 0.40873097E+01 0.64200000E+00 0.12156242E+02 0.40528851E+01 0.40515601E+01 0.40517970E+01 0.64220000E+00 0.12014425E+02 0.40056296E+01 0.40043177E+01 0.40044773E+01 0.64240000E+00 0.11839736E+02 0.39474132E+01 0.39461180E+01 0.39462049E+01 0.64260000E+00 0.11635195E+02 0.38792418E+01 0.38779668E+01 0.38779864E+01 0.64280000E+00 0.11404156E+02 0.38022337E+01 0.38009821E+01 0.38009406E+01 0.64300000E+00 0.11150187E+02 0.37175781E+01 0.37163525E+01 0.37162565E+01 0.64320000E+00 0.10876945E+02 0.36264943E+01 0.36252971E+01 0.36251535E+01 0.64340000E+00 0.10588069E+02 0.35301957E+01 0.35290288E+01 0.35288444E+01 0.64360000E+00 0.10287086E+02 0.34298581E+01 0.34287230E+01 0.34285046E+01 0.64380000E+00 0.99773322E+01 0.33265942E+01 0.33254920E+01 0.33252460E+01 0.64400000E+00 0.96618992E+01 0.32214345E+01 0.32203662E+01 0.32200984E+01 0.64420000E+00 0.93435913E+01 0.31153145E+01 0.31142804E+01 0.31139963E+01 0.64440000E+00 0.90249049E+01 0.30090666E+01 0.30080670E+01 0.30077714E+01 0.64460000E+00 0.87080204E+01 0.29034178E+01 0.29024526E+01 0.29021500E+01 0.64480000E+00 0.83948053E+01 0.27989912E+01 0.27980601E+01 0.27977540E+01 0.64500000E+00 0.80868275E+01 0.26963096E+01 0.26954121E+01 0.26951058E+01 0.64520000E+00 0.77853739E+01 0.25958022E+01 0.25949378E+01 0.25946339E+01 0.64540000E+00 0.74914747E+01 0.24978128E+01 0.24969806E+01 0.24966814E+01 0.64560000E+00 0.72059284E+01 0.24026076E+01 0.24018068E+01 0.24015140E+01 0.64580000E+00 0.69293290E+01 0.23103848E+01 0.23096145E+01 0.23093296E+01 0.64600000E+00 0.66620919E+01 0.22212832E+01 0.22205424E+01 0.22202663E+01 0.64620000E+00 0.64044797E+01 0.21353902E+01 0.21346779E+01 0.21344116E+01 0.64640000E+00 0.61566249E+01 0.20527503E+01 0.20520653E+01 0.20518093E+01 0.64660000E+00 0.59185519E+01 0.19733715E+01 0.19727129E+01 0.19724675E+01 0.64680000E+00 0.56901962E+01 0.18972325E+01 0.18965992E+01 0.18963646E+01 0.64700000E+00 0.54714211E+01 0.18242877E+01 0.18236786E+01 0.18234548E+01 0.64720000E+00 0.52620327E+01 0.17544725E+01 0.17538866E+01 0.17536737E+01 0.64740000E+00 0.50617930E+01 0.16877076E+01 0.16871439E+01 0.16869416E+01 0.64760000E+00 0.48704303E+01 0.16239024E+01 0.16233599E+01 0.16231680E+01 0.64780000E+00 0.46876488E+01 0.15629583E+01 0.15624362E+01 0.15622543E+01 0.64800000E+00 0.45131360E+01 0.15047712E+01 0.15042684E+01 0.15040964E+01 0.64820000E+00 0.43465695E+01 0.14492336E+01 0.14487493E+01 0.14485867E+01 0.64840000E+00 0.41876219E+01 0.13962363E+01 0.13957696E+01 0.13956160E+01 0.64860000E+00 0.40359650E+01 0.13456698E+01 0.13452200E+01 0.13450751E+01 0.64880000E+00 0.38912733E+01 0.12974258E+01 0.12969921E+01 0.12968554E+01 0.64900000E+00 0.37532266E+01 0.12513974E+01 0.12509790E+01 0.12508502E+01 0.64920000E+00 0.36215120E+01 0.12074803E+01 0.12070765E+01 0.12069552E+01 0.64940000E+00 0.34958258E+01 0.11655732E+01 0.11651833E+01 0.11650692E+01 0.64960000E+00 0.33758738E+01 0.11255781E+01 0.11252015E+01 0.11250942E+01 0.64980000E+00 0.32613731E+01 0.10874006E+01 0.10870367E+01 0.10869358E+01 0.65000000E+00 0.31520517E+01 0.10509500E+01 0.10505983E+01 0.10505034E+01 0.65020000E+00 0.30476494E+01 0.10161397E+01 0.10157995E+01 0.10157103E+01 0.65040000E+00 0.29479177E+01 0.98288656E+00 0.98255745E+00 0.98247366E+00 0.65060000E+00 0.28526194E+01 0.95111173E+00 0.95079318E+00 0.95071450E+00 0.65080000E+00 0.27615291E+01 0.92073995E+00 0.92043149E+00 0.92035764E+00 0.65100000E+00 0.26744324E+01 0.89169976E+00 0.89140095E+00 0.89133164E+00 0.65120000E+00 0.25911257E+01 0.86392331E+00 0.86363372E+00 0.86356871E+00 0.65140000E+00 0.25114163E+01 0.83734627E+00 0.83706550E+00 0.83700453E+00 0.65160000E+00 0.24351212E+01 0.81190766E+00 0.81163533E+00 0.81157818E+00 0.65180000E+00 0.23620673E+01 0.78754978E+00 0.78728553E+00 0.78723197E+00 0.65200000E+00 0.22920908E+01 0.76421800E+00 0.76396149E+00 0.76391132E+00 0.65220000E+00 0.22250368E+01 0.74186065E+00 0.74161155E+00 0.74156457E+00 0.65240000E+00 0.21607587E+01 0.72042888E+00 0.72018687E+00 0.72014291E+00 0.65260000E+00 0.20991179E+01 0.69987648E+00 0.69964128E+00 0.69960016E+00 0.65280000E+00 0.20399836E+01 0.68015982E+00 0.67993114E+00 0.67989269E+00 0.65300000E+00 0.19832321E+01 0.66123761E+00 0.66101520E+00 0.66097927E+00 0.65320000E+00 0.19287463E+01 0.64307088E+00 0.64285447E+00 0.64282092E+00 0.65340000E+00 0.18764157E+01 0.62562276E+00 0.62541213E+00 0.62538082E+00 0.65360000E+00 0.18261359E+01 0.60885845E+00 0.60865335E+00 0.60862415E+00 0.65380000E+00 0.17778083E+01 0.59274500E+00 0.59254523E+00 0.59251802E+00 0.65400000E+00 0.17313393E+01 0.57725132E+00 0.57705667E+00 0.57703134E+00 0.65420000E+00 0.16866409E+01 0.56234798E+00 0.56215825E+00 0.56213469E+00 0.65440000E+00 0.16436296E+01 0.54800717E+00 0.54782216E+00 0.54780027E+00 0.65460000E+00 0.16022265E+01 0.53420256E+00 0.53402211E+00 0.53400180E+00 0.65480000E+00 0.15623569E+01 0.52090928E+00 0.52073321E+00 0.52071439E+00 0.65500000E+00 0.15239502E+01 0.50810376E+00 0.50793191E+00 0.50791450E+00 0.65520000E+00 0.14869395E+01 0.49576372E+00 0.49559593E+00 0.49557984E+00 0.65540000E+00 0.14512615E+01 0.48386804E+00 0.48370417E+00 0.48368933E+00 0.65560000E+00 0.14168564E+01 0.47239674E+00 0.47223664E+00 0.47222299E+00 0.65580000E+00 0.13836672E+01 0.46133088E+00 0.46117442E+00 0.46116188E+00 0.65600000E+00 0.13516401E+01 0.45065251E+00 0.45049955E+00 0.45048807E+00 0.65620000E+00 0.13207242E+01 0.44034461E+00 0.44019505E+00 0.44018456E+00 0.65640000E+00 0.12908711E+01 0.43039106E+00 0.43024476E+00 0.43023522E+00 0.65660000E+00 0.12620347E+01 0.42077656E+00 0.42063341E+00 0.42062476E+00 0.65680000E+00 0.12341717E+01 0.41148657E+00 0.41134647E+00 0.41133866E+00 0.65700000E+00 0.12072406E+01 0.40250732E+00 0.40237016E+00 0.40236315E+00 0.65720000E+00 0.11812023E+01 0.39382571E+00 0.39369140E+00 0.39368514E+00 0.65740000E+00 0.11560193E+01 0.38542932E+00 0.38529776E+00 0.38529221E+00 0.65760000E+00 0.11316563E+01 0.37730632E+00 0.37717741E+00 0.37717254E+00 0.65780000E+00 0.11080795E+01 0.36944548E+00 0.36931915E+00 0.36931491E+00 0.65800000E+00 0.10852571E+01 0.36183613E+00 0.36171228E+00 0.36170864E+00 0.65820000E+00 0.10631583E+01 0.35446810E+00 0.35434666E+00 0.35434359E+00 0.65840000E+00 0.10417544E+01 0.34733172E+00 0.34721261E+00 0.34721008E+00 0.65860000E+00 0.10210177E+01 0.34041779E+00 0.34030094E+00 0.34029892E+00 0.65880000E+00 0.10009218E+01 0.33371755E+00 0.33360288E+00 0.33360135E+00 0.65900000E+00 0.98144175E+00 0.32722265E+00 0.32711009E+00 0.32710901E+00 0.65920000E+00 0.96255370E+00 0.32092512E+00 0.32081461E+00 0.32081397E+00 0.65940000E+00 0.94423488E+00 0.31481739E+00 0.31470887E+00 0.31470863E+00 0.65960000E+00 0.92646361E+00 0.30889221E+00 0.30878562E+00 0.30878577E+00 0.65980000E+00 0.90921917E+00 0.30314270E+00 0.30303797E+00 0.30303850E+00 0.66000000E+00 0.89248183E+00 0.29756227E+00 0.29745935E+00 0.29746022E+00 0.66020000E+00 0.87623274E+00 0.29214462E+00 0.29204346E+00 0.29204466E+00 0.66040000E+00 0.86045388E+00 0.28688376E+00 0.28678430E+00 0.28678581E+00 0.66060000E+00 0.84512806E+00 0.28177395E+00 0.28167615E+00 0.28167796E+00 0.66080000E+00 0.83023885E+00 0.27680972E+00 0.27671352E+00 0.27671561E+00 0.66100000E+00 0.81577055E+00 0.27198582E+00 0.27189119E+00 0.27189354E+00 0.66120000E+00 0.80170812E+00 0.26729726E+00 0.26720413E+00 0.26720673E+00 0.66140000E+00 0.78803721E+00 0.26273922E+00 0.26264757E+00 0.26265041E+00 0.66160000E+00 0.77474406E+00 0.25830715E+00 0.25821692E+00 0.25821999E+00 0.66180000E+00 0.76181552E+00 0.25399664E+00 0.25390780E+00 0.25391108E+00 0.66200000E+00 0.74923899E+00 0.24980349E+00 0.24971601E+00 0.24971949E+00 0.66220000E+00 0.73700240E+00 0.24572370E+00 0.24563752E+00 0.24564119E+00 0.66240000E+00 0.72509421E+00 0.24175339E+00 0.24166849E+00 0.24167233E+00 0.66260000E+00 0.71350332E+00 0.23788888E+00 0.23780521E+00 0.23780923E+00 0.66280000E+00 0.70221913E+00 0.23412662E+00 0.23404416E+00 0.23404834E+00 0.66300000E+00 0.69123145E+00 0.23046323E+00 0.23038194E+00 0.23038628E+00 0.66320000E+00 0.68053051E+00 0.22689544E+00 0.22681530E+00 0.22681977E+00 0.66340000E+00 0.67010695E+00 0.22342013E+00 0.22334110E+00 0.22334572E+00 0.66360000E+00 0.65995177E+00 0.22003431E+00 0.21995636E+00 0.21996110E+00 0.66380000E+00 0.65005634E+00 0.21673509E+00 0.21665819E+00 0.21666306E+00 0.66400000E+00 0.64041237E+00 0.21351972E+00 0.21344384E+00 0.21344882E+00 0.66420000E+00 0.63101190E+00 0.21038553E+00 0.21031064E+00 0.21031573E+00 0.66440000E+00 0.62184728E+00 0.20732997E+00 0.20725605E+00 0.20726125E+00 0.66460000E+00 0.61291114E+00 0.20435060E+00 0.20427763E+00 0.20428292E+00 0.66480000E+00 0.60419644E+00 0.20144505E+00 0.20137300E+00 0.20137839E+00 0.66500000E+00 0.59569636E+00 0.19861107E+00 0.19853991E+00 0.19854538E+00 0.66520000E+00 0.58740437E+00 0.19584646E+00 0.19577618E+00 0.19578173E+00 0.66540000E+00 0.57931419E+00 0.19314914E+00 0.19307971E+00 0.19308534E+00 0.66560000E+00 0.57141975E+00 0.19051709E+00 0.19044848E+00 0.19045418E+00 0.66580000E+00 0.56371524E+00 0.18794836E+00 0.18788055E+00 0.18788633E+00 0.66600000E+00 0.55619504E+00 0.18544108E+00 0.18537406E+00 0.18537990E+00 0.66620000E+00 0.54885375E+00 0.18299345E+00 0.18292720E+00 0.18293310E+00 0.66640000E+00 0.54168618E+00 0.18060374E+00 0.18053824E+00 0.18054420E+00 0.66660000E+00 0.53468730E+00 0.17827028E+00 0.17820550E+00 0.17821152E+00 0.66680000E+00 0.52785228E+00 0.17599145E+00 0.17592738E+00 0.17593345E+00 0.66700000E+00 0.52117648E+00 0.17376571E+00 0.17370233E+00 0.17370844E+00 0.66720000E+00 0.51465539E+00 0.17159155E+00 0.17152884E+00 0.17153500E+00 0.66740000E+00 0.50828468E+00 0.16946753E+00 0.16940548E+00 0.16941168E+00 0.66760000E+00 0.50206019E+00 0.16739225E+00 0.16733085E+00 0.16733709E+00 0.66780000E+00 0.49597787E+00 0.16536439E+00 0.16530361E+00 0.16530988E+00 0.66800000E+00 0.49003385E+00 0.16338263E+00 0.16332246E+00 0.16332877E+00 0.66820000E+00 0.48422437E+00 0.16144573E+00 0.16138615E+00 0.16139249E+00 0.66840000E+00 0.47854580E+00 0.15955247E+00 0.15949347E+00 0.15949985E+00 0.66860000E+00 0.47299464E+00 0.15770170E+00 0.15764327E+00 0.15764967E+00 0.66880000E+00 0.46756752E+00 0.15589229E+00 0.15583440E+00 0.15584083E+00 0.66900000E+00 0.46226117E+00 0.15412314E+00 0.15406579E+00 0.15407224E+00 0.66920000E+00 0.45707244E+00 0.15239320E+00 0.15233638E+00 0.15234286E+00 0.66940000E+00 0.45199827E+00 0.15070147E+00 0.15064515E+00 0.15065165E+00 0.66960000E+00 0.44703573E+00 0.14904695E+00 0.14899113E+00 0.14899765E+00 0.66980000E+00 0.44218196E+00 0.14742869E+00 0.14737336E+00 0.14737990E+00 0.67000000E+00 0.43743421E+00 0.14584579E+00 0.14579093E+00 0.14579749E+00 0.67020000E+00 0.43278982E+00 0.14429735E+00 0.14424295E+00 0.14424952E+00 0.67040000E+00 0.42824622E+00 0.14278251E+00 0.14272856E+00 0.14273515E+00 0.67060000E+00 0.42380090E+00 0.14130044E+00 0.14124693E+00 0.14125353E+00 0.67080000E+00 0.41945146E+00 0.13985033E+00 0.13979726E+00 0.13980387E+00 0.67100000E+00 0.41519557E+00 0.13843142E+00 0.13837876E+00 0.13838539E+00 0.67120000E+00 0.41103096E+00 0.13704294E+00 0.13699069E+00 0.13699733E+00 0.67140000E+00 0.40695545E+00 0.13568417E+00 0.13563232E+00 0.13563896E+00 0.67160000E+00 0.40296693E+00 0.13435441E+00 0.13430294E+00 0.13430959E+00 0.67180000E+00 0.39906335E+00 0.13305296E+00 0.13300186E+00 0.13300853E+00 0.67200000E+00 0.39524271E+00 0.13177916E+00 0.13172844E+00 0.13173511E+00 0.67220000E+00 0.39150310E+00 0.13053238E+00 0.13048202E+00 0.13048870E+00 0.67240000E+00 0.38784265E+00 0.12931200E+00 0.12926198E+00 0.12926867E+00 0.67260000E+00 0.38425957E+00 0.12811741E+00 0.12806773E+00 0.12807442E+00 0.67280000E+00 0.38075209E+00 0.12694803E+00 0.12689868E+00 0.12690538E+00 0.67300000E+00 0.37731853E+00 0.12580329E+00 0.12575427E+00 0.12576097E+00 0.67320000E+00 0.37395725E+00 0.12468265E+00 0.12463395E+00 0.12464065E+00 0.67340000E+00 0.37066664E+00 0.12358558E+00 0.12353718E+00 0.12354388E+00 0.67360000E+00 0.36744518E+00 0.12251156E+00 0.12246345E+00 0.12247016E+00 0.67380000E+00 0.36429135E+00 0.12146009E+00 0.12141227E+00 0.12141899E+00 0.67400000E+00 0.36120371E+00 0.12043069E+00 0.12038315E+00 0.12038987E+00 0.67420000E+00 0.35818085E+00 0.11942288E+00 0.11937562E+00 0.11938234E+00 0.67440000E+00 0.35522141E+00 0.11843622E+00 0.11838923E+00 0.11839595E+00 0.67460000E+00 0.35232406E+00 0.11747027E+00 0.11742353E+00 0.11743026E+00 0.67480000E+00 0.34948751E+00 0.11652458E+00 0.11647810E+00 0.11648483E+00 0.67500000E+00 0.34671053E+00 0.11559876E+00 0.11555252E+00 0.11555925E+00 0.67520000E+00 0.34399189E+00 0.11469239E+00 0.11464639E+00 0.11465312E+00 0.67540000E+00 0.34133043E+00 0.11380508E+00 0.11375931E+00 0.11376604E+00 0.67560000E+00 0.33872501E+00 0.11293645E+00 0.11289091E+00 0.11289764E+00 0.67580000E+00 0.33617452E+00 0.11208614E+00 0.11204082E+00 0.11204755E+00 0.67600000E+00 0.33367788E+00 0.11125379E+00 0.11120868E+00 0.11121541E+00 0.67620000E+00 0.33123407E+00 0.11043905E+00 0.11039414E+00 0.11040088E+00 0.67640000E+00 0.32884207E+00 0.10964158E+00 0.10959687E+00 0.10960361E+00 0.67660000E+00 0.32650089E+00 0.10886106E+00 0.10881655E+00 0.10882328E+00 0.67680000E+00 0.32420958E+00 0.10809717E+00 0.10805284E+00 0.10805958E+00 0.67700000E+00 0.32196723E+00 0.10734960E+00 0.10730545E+00 0.10731219E+00 0.67720000E+00 0.31977293E+00 0.10661804E+00 0.10657407E+00 0.10658081E+00 0.67740000E+00 0.31762581E+00 0.10590222E+00 0.10585842E+00 0.10586516E+00 0.67760000E+00 0.31552502E+00 0.10520185E+00 0.10515821E+00 0.10516496E+00 0.67780000E+00 0.31346975E+00 0.10451666E+00 0.10447317E+00 0.10447992E+00 0.67800000E+00 0.31145920E+00 0.10384637E+00 0.10380304E+00 0.10380979E+00 0.67820000E+00 0.30949259E+00 0.10319074E+00 0.10314755E+00 0.10315430E+00 0.67840000E+00 0.30756917E+00 0.10254950E+00 0.10250646E+00 0.10251321E+00 0.67860000E+00 0.30568821E+00 0.10192242E+00 0.10187952E+00 0.10188627E+00 0.67880000E+00 0.30384900E+00 0.10130927E+00 0.10126649E+00 0.10127325E+00 0.67900000E+00 0.30205087E+00 0.10070980E+00 0.10066715E+00 0.10067391E+00 0.67920000E+00 0.30029313E+00 0.10012381E+00 0.10008128E+00 0.10008804E+00 0.67940000E+00 0.29857514E+00 0.99551071E-01 0.99508651E-01 0.99515417E-01 0.67960000E+00 0.29689627E+00 0.98991375E-01 0.98949065E-01 0.98955835E-01 0.67980000E+00 0.29525592E+00 0.98444520E-01 0.98402315E-01 0.98409088E-01 0.68000000E+00 0.29365349E+00 0.97910308E-01 0.97868203E-01 0.97874980E-01 0.68020000E+00 0.29208841E+00 0.97388548E-01 0.97346538E-01 0.97353320E-01 0.68040000E+00 0.29056011E+00 0.96879054E-01 0.96837134E-01 0.96843921E-01 0.68060000E+00 0.28906806E+00 0.96381646E-01 0.96339811E-01 0.96346603E-01 0.68080000E+00 0.28761174E+00 0.95896149E-01 0.95854395E-01 0.95861192E-01 0.68100000E+00 0.28619063E+00 0.95422394E-01 0.95380715E-01 0.95387518E-01 0.68120000E+00 0.28480424E+00 0.94960216E-01 0.94918608E-01 0.94925417E-01 0.68140000E+00 0.28345210E+00 0.94509456E-01 0.94467914E-01 0.94474730E-01 0.68160000E+00 0.28213374E+00 0.94069958E-01 0.94028479E-01 0.94035302E-01 0.68180000E+00 0.28084871E+00 0.93641575E-01 0.93600153E-01 0.93606983E-01 0.68200000E+00 0.27959658E+00 0.93224160E-01 0.93182791E-01 0.93189629E-01 0.68220000E+00 0.27837693E+00 0.92817574E-01 0.92776253E-01 0.92783099E-01 0.68240000E+00 0.27718934E+00 0.92421680E-01 0.92380403E-01 0.92387257E-01 0.68260000E+00 0.27603343E+00 0.92036347E-01 0.91995109E-01 0.92001973E-01 0.68280000E+00 0.27490881E+00 0.91661447E-01 0.91620245E-01 0.91627118E-01 0.68300000E+00 0.27381511E+00 0.91296858E-01 0.91255686E-01 0.91262569E-01 0.68320000E+00 0.27275198E+00 0.90942460E-01 0.90901315E-01 0.90908208E-01 0.68340000E+00 0.27171907E+00 0.90598138E-01 0.90557015E-01 0.90563919E-01 0.68360000E+00 0.27071605E+00 0.90263782E-01 0.90222676E-01 0.90229592E-01 0.68380000E+00 0.26974259E+00 0.89939283E-01 0.89898191E-01 0.89905118E-01 0.68400000E+00 0.26879839E+00 0.89624539E-01 0.89583456E-01 0.89590395E-01 0.68420000E+00 0.26788314E+00 0.89319449E-01 0.89278371E-01 0.89285324E-01 0.68440000E+00 0.26699656E+00 0.89023918E-01 0.88982840E-01 0.88989806E-01 0.68460000E+00 0.26613837E+00 0.88737852E-01 0.88696771E-01 0.88703751E-01 0.68480000E+00 0.26530830E+00 0.88461162E-01 0.88420074E-01 0.88427068E-01 0.68500000E+00 0.26450610E+00 0.88193763E-01 0.88152663E-01 0.88159672E-01 0.68520000E+00 0.26373151E+00 0.87935573E-01 0.87894456E-01 0.87901481E-01 0.68540000E+00 0.26298430E+00 0.87686512E-01 0.87645375E-01 0.87652416E-01 0.68560000E+00 0.26226425E+00 0.87446504E-01 0.87405343E-01 0.87412401E-01 0.68580000E+00 0.26157113E+00 0.87215477E-01 0.87174287E-01 0.87181363E-01 0.68600000E+00 0.26090473E+00 0.86993361E-01 0.86952139E-01 0.86959232E-01 0.68620000E+00 0.26026486E+00 0.86780090E-01 0.86738831E-01 0.86745944E-01 0.68640000E+00 0.25965134E+00 0.86575601E-01 0.86534301E-01 0.86541433E-01 0.68660000E+00 0.25906396E+00 0.86379834E-01 0.86338489E-01 0.86345641E-01 0.68680000E+00 0.25850258E+00 0.86192731E-01 0.86151336E-01 0.86158509E-01 0.68700000E+00 0.25796701E+00 0.86014238E-01 0.85972790E-01 0.85979984E-01 0.68720000E+00 0.25745712E+00 0.85844304E-01 0.85802798E-01 0.85810014E-01 0.68740000E+00 0.25697274E+00 0.85682880E-01 0.85641312E-01 0.85648550E-01 0.68760000E+00 0.25651375E+00 0.85529920E-01 0.85488286E-01 0.85495548E-01 0.68780000E+00 0.25608002E+00 0.85385382E-01 0.85343678E-01 0.85350964E-01 0.68800000E+00 0.25567143E+00 0.85249225E-01 0.85207447E-01 0.85214758E-01 0.68820000E+00 0.25528786E+00 0.85121413E-01 0.85079556E-01 0.85086893E-01 0.68840000E+00 0.25492922E+00 0.85001911E-01 0.84959971E-01 0.84967334E-01 0.68860000E+00 0.25459540E+00 0.84890686E-01 0.84848659E-01 0.84856050E-01 0.68880000E+00 0.25428632E+00 0.84787711E-01 0.84745593E-01 0.84753011E-01 0.68900000E+00 0.25400189E+00 0.84692958E-01 0.84650744E-01 0.84658192E-01 0.68920000E+00 0.25374206E+00 0.84606404E-01 0.84564091E-01 0.84571568E-01 0.68940000E+00 0.25350676E+00 0.84528028E-01 0.84485610E-01 0.84493118E-01 0.68960000E+00 0.25329592E+00 0.84457811E-01 0.84415285E-01 0.84422824E-01 0.68980000E+00 0.25310951E+00 0.84395738E-01 0.84353099E-01 0.84360670E-01 0.69000000E+00 0.25294748E+00 0.84341795E-01 0.84299038E-01 0.84306642E-01 0.69020000E+00 0.25280980E+00 0.84295972E-01 0.84253093E-01 0.84260732E-01 0.69040000E+00 0.25269645E+00 0.84258260E-01 0.84215256E-01 0.84222929E-01 0.69060000E+00 0.25260741E+00 0.84228656E-01 0.84185521E-01 0.84193230E-01 0.69080000E+00 0.25254267E+00 0.84207155E-01 0.84163885E-01 0.84171630E-01 0.69100000E+00 0.25250224E+00 0.84193757E-01 0.84150348E-01 0.84158131E-01 0.69120000E+00 0.25248611E+00 0.84188467E-01 0.84144913E-01 0.84152735E-01 0.69140000E+00 0.25249432E+00 0.84191287E-01 0.84147585E-01 0.84155446E-01 0.69160000E+00 0.25252687E+00 0.84202227E-01 0.84158371E-01 0.84166273E-01 0.69180000E+00 0.25258380E+00 0.84221296E-01 0.84177282E-01 0.84185226E-01 0.69200000E+00 0.25266516E+00 0.84248507E-01 0.84204331E-01 0.84212318E-01 0.69220000E+00 0.25277097E+00 0.84283877E-01 0.84239533E-01 0.84247564E-01 0.69240000E+00 0.25290131E+00 0.84327423E-01 0.84282907E-01 0.84290983E-01 0.69260000E+00 0.25305624E+00 0.84379167E-01 0.84334474E-01 0.84342596E-01 0.69280000E+00 0.25323581E+00 0.84439131E-01 0.84394257E-01 0.84402426E-01 0.69300000E+00 0.25344013E+00 0.84507344E-01 0.84462282E-01 0.84470499E-01 0.69320000E+00 0.25366926E+00 0.84583833E-01 0.84538579E-01 0.84546846E-01 0.69340000E+00 0.25392331E+00 0.84668630E-01 0.84623180E-01 0.84631497E-01 0.69360000E+00 0.25420238E+00 0.84761771E-01 0.84716119E-01 0.84724488E-01 0.69380000E+00 0.25450658E+00 0.84863292E-01 0.84817433E-01 0.84825855E-01 0.69400000E+00 0.25483604E+00 0.84973234E-01 0.84927163E-01 0.84935640E-01 0.69420000E+00 0.25519088E+00 0.85091640E-01 0.85045352E-01 0.85053884E-01 0.69440000E+00 0.25557124E+00 0.85218557E-01 0.85172045E-01 0.85180635E-01 0.69460000E+00 0.25597726E+00 0.85354032E-01 0.85307292E-01 0.85315940E-01 0.69480000E+00 0.25640911E+00 0.85498118E-01 0.85451144E-01 0.85459852E-01 0.69500000E+00 0.25686695E+00 0.85650870E-01 0.85603657E-01 0.85612426E-01 0.69520000E+00 0.25735095E+00 0.85812345E-01 0.85764888E-01 0.85773719E-01 0.69540000E+00 0.25786130E+00 0.85982606E-01 0.85934898E-01 0.85943793E-01 0.69560000E+00 0.25839818E+00 0.86161715E-01 0.86113751E-01 0.86122712E-01 0.69580000E+00 0.25896180E+00 0.86349741E-01 0.86301515E-01 0.86310543E-01 0.69600000E+00 0.25955237E+00 0.86546753E-01 0.86498260E-01 0.86507356E-01 0.69620000E+00 0.26017011E+00 0.86752826E-01 0.86704059E-01 0.86713225E-01 0.69640000E+00 0.26081526E+00 0.86968037E-01 0.86918990E-01 0.86928228E-01 0.69660000E+00 0.26148805E+00 0.87192466E-01 0.87143134E-01 0.87152445E-01 0.69680000E+00 0.26218873E+00 0.87426198E-01 0.87376574E-01 0.87385960E-01 0.69700000E+00 0.26291758E+00 0.87669320E-01 0.87619397E-01 0.87628860E-01 0.69720000E+00 0.26367485E+00 0.87921922E-01 0.87871695E-01 0.87881236E-01 0.69740000E+00 0.26446085E+00 0.88184101E-01 0.88133562E-01 0.88143184E-01 0.69760000E+00 0.26527585E+00 0.88455954E-01 0.88405097E-01 0.88414801E-01 0.69780000E+00 0.26612018E+00 0.88737584E-01 0.88686402E-01 0.88696190E-01 0.69800000E+00 0.26699414E+00 0.89029096E-01 0.88977583E-01 0.88987457E-01 0.69820000E+00 0.26789806E+00 0.89330601E-01 0.89278750E-01 0.89288711E-01 0.69840000E+00 0.26883230E+00 0.89642214E-01 0.89590017E-01 0.89600068E-01 0.69860000E+00 0.26979720E+00 0.89964052E-01 0.89911503E-01 0.89921645E-01 0.69880000E+00 0.27079313E+00 0.90296238E-01 0.90243329E-01 0.90253565E-01 0.69900000E+00 0.27182048E+00 0.90638898E-01 0.90585623E-01 0.90595955E-01 0.69920000E+00 0.27287963E+00 0.90992165E-01 0.90938515E-01 0.90948945E-01 0.69940000E+00 0.27397099E+00 0.91356174E-01 0.91302142E-01 0.91312673E-01 0.69960000E+00 0.27509499E+00 0.91731066E-01 0.91676644E-01 0.91687277E-01 0.69980000E+00 0.27625205E+00 0.92116985E-01 0.92062165E-01 0.92072903E-01 0.70000000E+00 0.27744264E+00 0.92514083E-01 0.92458856E-01 0.92469702E-01 0.70020000E+00 0.27866721E+00 0.92922513E-01 0.92866873E-01 0.92877828E-01 0.70040000E+00 0.27992625E+00 0.93342436E-01 0.93286374E-01 0.93297441E-01 0.70060000E+00 0.28122025E+00 0.93774019E-01 0.93717525E-01 0.93728707E-01 0.70080000E+00 0.28254972E+00 0.94217431E-01 0.94160498E-01 0.94171797E-01 0.70100000E+00 0.28391520E+00 0.94672849E-01 0.94615467E-01 0.94626886E-01 0.70120000E+00 0.28531723E+00 0.95140455E-01 0.95082616E-01 0.95094158E-01 0.70140000E+00 0.28675637E+00 0.95620438E-01 0.95562133E-01 0.95573800E-01 0.70160000E+00 0.28823321E+00 0.96112991E-01 0.96054210E-01 0.96066005E-01 0.70180000E+00 0.28974834E+00 0.96618314E-01 0.96559048E-01 0.96570975E-01 0.70200000E+00 0.29130238E+00 0.97136615E-01 0.97076853E-01 0.97088914E-01 0.70220000E+00 0.29289598E+00 0.97668105E-01 0.97607839E-01 0.97620037E-01 0.70240000E+00 0.29452979E+00 0.98213006E-01 0.98152225E-01 0.98164563E-01 0.70260000E+00 0.29620450E+00 0.98771542E-01 0.98710236E-01 0.98722719E-01 0.70280000E+00 0.29792080E+00 0.99343950E-01 0.99282108E-01 0.99294737E-01 0.70300000E+00 0.29967941E+00 0.99930469E-01 0.99868081E-01 0.99880860E-01 0.70320000E+00 0.30148109E+00 0.10053135E+00 0.10046840E+00 0.10048134E+00 0.70340000E+00 0.30332660E+00 0.10114684E+00 0.10108333E+00 0.10109642E+00 0.70360000E+00 0.30521673E+00 0.10177722E+00 0.10171313E+00 0.10172638E+00 0.70380000E+00 0.30715231E+00 0.10242275E+00 0.10235807E+00 0.10237149E+00 0.70400000E+00 0.30913418E+00 0.10308372E+00 0.10301843E+00 0.10303202E+00 0.70420000E+00 0.31116320E+00 0.10376042E+00 0.10369451E+00 0.10370827E+00 0.70440000E+00 0.31324028E+00 0.10445314E+00 0.10438660E+00 0.10440054E+00 0.70460000E+00 0.31536634E+00 0.10516219E+00 0.10509502E+00 0.10510913E+00 0.70480000E+00 0.31754233E+00 0.10588789E+00 0.10582007E+00 0.10583437E+00 0.70500000E+00 0.31976925E+00 0.10663058E+00 0.10656209E+00 0.10657658E+00 0.70520000E+00 0.32204810E+00 0.10739059E+00 0.10732141E+00 0.10733610E+00 0.70540000E+00 0.32437993E+00 0.10816826E+00 0.10809839E+00 0.10811328E+00 0.70560000E+00 0.32676583E+00 0.10896396E+00 0.10889339E+00 0.10890848E+00 0.70580000E+00 0.32920690E+00 0.10977807E+00 0.10970677E+00 0.10972207E+00 0.70600000E+00 0.33170431E+00 0.11061096E+00 0.11053892E+00 0.11055443E+00 0.70620000E+00 0.33425923E+00 0.11146303E+00 0.11139024E+00 0.11140597E+00 0.70640000E+00 0.33687289E+00 0.11233468E+00 0.11226113E+00 0.11227708E+00 0.70660000E+00 0.33954655E+00 0.11322635E+00 0.11315201E+00 0.11316819E+00 0.70680000E+00 0.34228153E+00 0.11413846E+00 0.11406332E+00 0.11407974E+00 0.70700000E+00 0.34507916E+00 0.11507147E+00 0.11499552E+00 0.11501217E+00 0.70720000E+00 0.34794083E+00 0.11602584E+00 0.11594905E+00 0.11596595E+00 0.70740000E+00 0.35086798E+00 0.11700204E+00 0.11692440E+00 0.11694155E+00 0.70760000E+00 0.35386209E+00 0.11800057E+00 0.11792206E+00 0.11793947E+00 0.70780000E+00 0.35692470E+00 0.11902194E+00 0.11894254E+00 0.11896022E+00 0.70800000E+00 0.36005737E+00 0.12006668E+00 0.11998637E+00 0.12000432E+00 0.70820000E+00 0.36326175E+00 0.12113533E+00 0.12105410E+00 0.12107233E+00 0.70840000E+00 0.36653951E+00 0.12222845E+00 0.12214627E+00 0.12216479E+00 0.70860000E+00 0.36989240E+00 0.12334662E+00 0.12326348E+00 0.12328229E+00 0.70880000E+00 0.37332222E+00 0.12449046E+00 0.12440633E+00 0.12442544E+00 0.70900000E+00 0.37683083E+00 0.12566056E+00 0.12557542E+00 0.12559484E+00 0.70920000E+00 0.38042015E+00 0.12685758E+00 0.12677141E+00 0.12679115E+00 0.70940000E+00 0.38409216E+00 0.12808218E+00 0.12799496E+00 0.12801502E+00 0.70960000E+00 0.38784893E+00 0.12933504E+00 0.12924675E+00 0.12926714E+00 0.70980000E+00 0.39169257E+00 0.13061687E+00 0.13052748E+00 0.13054822E+00 0.71000000E+00 0.39562528E+00 0.13192841E+00 0.13183789E+00 0.13185898E+00 0.71020000E+00 0.39964935E+00 0.13327041E+00 0.13317874E+00 0.13320019E+00 0.71040000E+00 0.40376711E+00 0.13464365E+00 0.13455082E+00 0.13457263E+00 0.71060000E+00 0.40798099E+00 0.13604896E+00 0.13595492E+00 0.13597712E+00 0.71080000E+00 0.41229353E+00 0.13748716E+00 0.13739189E+00 0.13741448E+00 0.71100000E+00 0.41670733E+00 0.13895913E+00 0.13886261E+00 0.13888560E+00 0.71120000E+00 0.42122508E+00 0.14046576E+00 0.14036796E+00 0.14039136E+00 0.71140000E+00 0.42584958E+00 0.14200800E+00 0.14190888E+00 0.14193270E+00 0.71160000E+00 0.43058373E+00 0.14358680E+00 0.14348634E+00 0.14351060E+00 0.71180000E+00 0.43543053E+00 0.14520317E+00 0.14510133E+00 0.14512603E+00 0.71200000E+00 0.44039307E+00 0.14685813E+00 0.14675489E+00 0.14678005E+00 0.71220000E+00 0.44547460E+00 0.14855278E+00 0.14844809E+00 0.14847373E+00 0.71240000E+00 0.45067843E+00 0.15028821E+00 0.15018205E+00 0.15020817E+00 0.71260000E+00 0.45600805E+00 0.15206559E+00 0.15195792E+00 0.15198454E+00 0.71280000E+00 0.46146702E+00 0.15388611E+00 0.15377689E+00 0.15380403E+00 0.71300000E+00 0.46705909E+00 0.15575101E+00 0.15564021E+00 0.15566787E+00 0.71320000E+00 0.47278812E+00 0.15766158E+00 0.15754917E+00 0.15757737E+00 0.71340000E+00 0.47865811E+00 0.15961917E+00 0.15950509E+00 0.15953386E+00 0.71360000E+00 0.48467323E+00 0.16162515E+00 0.16150937E+00 0.16153871E+00 0.71380000E+00 0.49083780E+00 0.16368097E+00 0.16356345E+00 0.16359338E+00 0.71400000E+00 0.49715631E+00 0.16578812E+00 0.16566882E+00 0.16569936E+00 0.71420000E+00 0.50363341E+00 0.16794817E+00 0.16782703E+00 0.16785821E+00 0.71440000E+00 0.51027397E+00 0.17016272E+00 0.17003971E+00 0.17007153E+00 0.71460000E+00 0.51708300E+00 0.17243346E+00 0.17230853E+00 0.17234101E+00 0.71480000E+00 0.52406575E+00 0.17476213E+00 0.17463522E+00 0.17466839E+00 0.71500000E+00 0.53122765E+00 0.17715055E+00 0.17702161E+00 0.17705549E+00 0.71520000E+00 0.53857437E+00 0.17960059E+00 0.17946958E+00 0.17950419E+00 0.71540000E+00 0.54611179E+00 0.18211424E+00 0.18198110E+00 0.18201646E+00 0.71560000E+00 0.55384605E+00 0.18469352E+00 0.18455820E+00 0.18459434E+00 0.71580000E+00 0.56178353E+00 0.18734058E+00 0.18720301E+00 0.18723995E+00 0.71600000E+00 0.56993086E+00 0.19005761E+00 0.18991774E+00 0.18995551E+00 0.71620000E+00 0.57829496E+00 0.19284694E+00 0.19270470E+00 0.19274332E+00 0.71640000E+00 0.58688305E+00 0.19571096E+00 0.19556629E+00 0.19560579E+00 0.71660000E+00 0.59570263E+00 0.19865218E+00 0.19850502E+00 0.19854543E+00 0.71680000E+00 0.60476154E+00 0.20167321E+00 0.20152349E+00 0.20156484E+00 0.71700000E+00 0.61406793E+00 0.20477678E+00 0.20462442E+00 0.20466673E+00 0.71720000E+00 0.62363033E+00 0.20796571E+00 0.20781065E+00 0.20785397E+00 0.71740000E+00 0.63345762E+00 0.21124299E+00 0.21108514E+00 0.21112949E+00 0.71760000E+00 0.64355907E+00 0.21461169E+00 0.21445098E+00 0.21449640E+00 0.71780000E+00 0.65394437E+00 0.21807505E+00 0.21791140E+00 0.21795793E+00 0.71800000E+00 0.66462363E+00 0.22163644E+00 0.22146976E+00 0.22151743E+00 0.71820000E+00 0.67560741E+00 0.22529938E+00 0.22512959E+00 0.22517844E+00 0.71840000E+00 0.68690676E+00 0.22906756E+00 0.22889456E+00 0.22894464E+00 0.71860000E+00 0.69853320E+00 0.23294482E+00 0.23276852E+00 0.23281987E+00 0.71880000E+00 0.71049881E+00 0.23693518E+00 0.23675548E+00 0.23680814E+00 0.71900000E+00 0.72281621E+00 0.24104286E+00 0.24085966E+00 0.24091368E+00 0.71920000E+00 0.73549860E+00 0.24527226E+00 0.24508546E+00 0.24514089E+00 0.71940000E+00 0.74855982E+00 0.24962799E+00 0.24943747E+00 0.24949436E+00 0.71960000E+00 0.76201434E+00 0.25411488E+00 0.25392053E+00 0.25397893E+00 0.71980000E+00 0.77587732E+00 0.25873798E+00 0.25853969E+00 0.25859966E+00 0.72000000E+00 0.79016466E+00 0.26350260E+00 0.26330023E+00 0.26336183E+00 0.72020000E+00 0.80489300E+00 0.26841428E+00 0.26820772E+00 0.26827100E+00 0.72040000E+00 0.82007982E+00 0.27347886E+00 0.27326797E+00 0.27333300E+00 0.72060000E+00 0.83574343E+00 0.27870244E+00 0.27848707E+00 0.27855392E+00 0.72080000E+00 0.85190306E+00 0.28409143E+00 0.28387145E+00 0.28394018E+00 0.72100000E+00 0.86857888E+00 0.28965256E+00 0.28942781E+00 0.28949851E+00 0.72120000E+00 0.88579207E+00 0.29539289E+00 0.29516322E+00 0.29523596E+00 0.72140000E+00 0.90356490E+00 0.30131985E+00 0.30108510E+00 0.30115995E+00 0.72160000E+00 0.92192076E+00 0.30744124E+00 0.30720123E+00 0.30727828E+00 0.72180000E+00 0.94088422E+00 0.31376526E+00 0.31351981E+00 0.31359915E+00 0.72200000E+00 0.96048114E+00 0.32030052E+00 0.32004945E+00 0.32013117E+00 0.72220000E+00 0.98073872E+00 0.32705609E+00 0.32679921E+00 0.32688342E+00 0.72240000E+00 0.10016856E+01 0.33404153E+00 0.33377863E+00 0.33386542E+00 0.72260000E+00 0.10233518E+01 0.34126687E+00 0.34099774E+00 0.34108722E+00 0.72280000E+00 0.10457692E+01 0.34874271E+00 0.34846713E+00 0.34855940E+00 0.72300000E+00 0.10689712E+01 0.35648017E+00 0.35619791E+00 0.35629311E+00 0.72320000E+00 0.10929929E+01 0.36449102E+00 0.36420184E+00 0.36430008E+00 0.72340000E+00 0.11178716E+01 0.37278764E+00 0.37249128E+00 0.37259270E+00 0.72360000E+00 0.11436464E+01 0.38138307E+00 0.38107927E+00 0.38118401E+00 0.72380000E+00 0.11703585E+01 0.39029111E+00 0.38997960E+00 0.39008779E+00 0.72400000E+00 0.11980516E+01 0.39952629E+00 0.39920677E+00 0.39931857E+00 0.72420000E+00 0.12267718E+01 0.40910395E+00 0.40877612E+00 0.40889169E+00 0.72440000E+00 0.12565675E+01 0.41904031E+00 0.41870384E+00 0.41882336E+00 0.72460000E+00 0.12874902E+01 0.42935246E+00 0.42900703E+00 0.42913067E+00 0.72480000E+00 0.13195940E+01 0.44005850E+00 0.43970375E+00 0.43983171E+00 0.72500000E+00 0.13529362E+01 0.45117755E+00 0.45081311E+00 0.45094557E+00 0.72520000E+00 0.13875775E+01 0.46272979E+00 0.46235528E+00 0.46249246E+00 0.72540000E+00 0.14235819E+01 0.47473658E+00 0.47435160E+00 0.47449372E+00 0.72560000E+00 0.14610171E+01 0.48722053E+00 0.48682464E+00 0.48697193E+00 0.72580000E+00 0.14999548E+01 0.50020550E+00 0.49979827E+00 0.49995098E+00 0.72600000E+00 0.15404707E+01 0.51371679E+00 0.51329773E+00 0.51345613E+00 0.72620000E+00 0.15826450E+01 0.52778113E+00 0.52734975E+00 0.52751410E+00 0.72640000E+00 0.16265626E+01 0.54242681E+00 0.54198259E+00 0.54215319E+00 0.72660000E+00 0.16723132E+01 0.55768376E+00 0.55722615E+00 0.55740331E+00 0.72680000E+00 0.17199919E+01 0.57358365E+00 0.57311208E+00 0.57329612E+00 0.72700000E+00 0.17696990E+01 0.59016000E+00 0.58967386E+00 0.58986512E+00 0.72720000E+00 0.18215409E+01 0.60744825E+00 0.60694689E+00 0.60714574E+00 0.72740000E+00 0.18756300E+01 0.62548589E+00 0.62496864E+00 0.62517546E+00 0.72760000E+00 0.19320851E+01 0.64431254E+00 0.64377870E+00 0.64399389E+00 0.72780000E+00 0.19910319E+01 0.66397010E+00 0.66341891E+00 0.66364290E+00 0.72800000E+00 0.20526030E+01 0.68450280E+00 0.68393347E+00 0.68416672E+00 0.72820000E+00 0.21169385E+01 0.70595736E+00 0.70536906E+00 0.70561204E+00 0.72840000E+00 0.21841860E+01 0.72838303E+00 0.72777489E+00 0.72802810E+00 0.72860000E+00 0.22545014E+01 0.75183174E+00 0.75120283E+00 0.75146680E+00 0.72880000E+00 0.23280484E+01 0.77635814E+00 0.77570749E+00 0.77598278E+00 0.72900000E+00 0.24049994E+01 0.80201968E+00 0.80134626E+00 0.80163345E+00 0.72920000E+00 0.24855351E+01 0.82887666E+00 0.82817938E+00 0.82847910E+00 0.72940000E+00 0.25698451E+01 0.85699224E+00 0.85626998E+00 0.85658287E+00 0.72960000E+00 0.26581272E+01 0.88643247E+00 0.88568402E+00 0.88601076E+00 0.72980000E+00 0.27505880E+01 0.91726617E+00 0.91649027E+00 0.91683157E+00 0.73000000E+00 0.28474419E+01 0.94956489E+00 0.94876021E+00 0.94911682E+00 0.73020000E+00 0.29489111E+01 0.98340270E+00 0.98256785E+00 0.98294053E+00 0.73040000E+00 0.30552244E+01 0.10188560E+01 0.10179895E+01 0.10183790E+01 0.73060000E+00 0.31666168E+01 0.10560029E+01 0.10551033E+01 0.10555105E+01 0.73080000E+00 0.32833272E+01 0.10949234E+01 0.10939890E+01 0.10944148E+01 0.73100000E+00 0.34055977E+01 0.11356981E+01 0.11347272E+01 0.11351724E+01 0.73120000E+00 0.35336701E+01 0.11784076E+01 0.11773985E+01 0.11778640E+01 0.73140000E+00 0.36677839E+01 0.12231318E+01 0.12220827E+01 0.12225694E+01 0.73160000E+00 0.38081724E+01 0.12699485E+01 0.12688575E+01 0.12693663E+01 0.73180000E+00 0.39550580E+01 0.13189320E+01 0.13177971E+01 0.13183288E+01 0.73200000E+00 0.41086472E+01 0.13701510E+01 0.13689703E+01 0.13695258E+01 0.73220000E+00 0.42691239E+01 0.14236670E+01 0.14224384E+01 0.14230185E+01 0.73240000E+00 0.44366421E+01 0.14795314E+01 0.14782527E+01 0.14788581E+01 0.73260000E+00 0.46113166E+01 0.15377823E+01 0.15364514E+01 0.15370829E+01 0.73280000E+00 0.47932127E+01 0.15984417E+01 0.15970565E+01 0.15977145E+01 0.73300000E+00 0.49823344E+01 0.16615109E+01 0.16600693E+01 0.16607543E+01 0.73320000E+00 0.51786107E+01 0.17269663E+01 0.17254661E+01 0.17261783E+01 0.73340000E+00 0.53818808E+01 0.17947543E+01 0.17931935E+01 0.17939330E+01 0.73360000E+00 0.55918773E+01 0.18647858E+01 0.18631625E+01 0.18639289E+01 0.73380000E+00 0.58082088E+01 0.19369304E+01 0.19352428E+01 0.19360356E+01 0.73400000E+00 0.60303411E+01 0.20110100E+01 0.20092564E+01 0.20100747E+01 0.73420000E+00 0.62575788E+01 0.20867927E+01 0.20849718E+01 0.20858143E+01 0.73440000E+00 0.64890468E+01 0.21639869E+01 0.21620975E+01 0.21629624E+01 0.73460000E+00 0.67236742E+01 0.22422354E+01 0.22402769E+01 0.22411619E+01 0.73480000E+00 0.69601804E+01 0.23211114E+01 0.23190833E+01 0.23199857E+01 0.73500000E+00 0.71970666E+01 0.24001150E+01 0.23980177E+01 0.23989339E+01 0.73520000E+00 0.74326132E+01 0.24786730E+01 0.24765070E+01 0.24774332E+01 0.73540000E+00 0.76648854E+01 0.25561400E+01 0.25539069E+01 0.25548384E+01 0.73560000E+00 0.78917493E+01 0.26318047E+01 0.26295064E+01 0.26304381E+01 0.73580000E+00 0.81108994E+01 0.27048982E+01 0.27025375E+01 0.27034638E+01 0.73600000E+00 0.83198994E+01 0.27746079E+01 0.27721883E+01 0.27731032E+01 0.73620000E+00 0.85162358E+01 0.28400957E+01 0.28376216E+01 0.28385186E+01 0.73640000E+00 0.86973841E+01 0.29005195E+01 0.28979960E+01 0.28988686E+01 0.73660000E+00 0.88608860E+01 0.29550594E+01 0.29524924E+01 0.29533342E+01 0.73680000E+00 0.90044338E+01 0.30029456E+01 0.30003418E+01 0.30011464E+01 0.73700000E+00 0.91259578E+01 0.30434877E+01 0.30408543E+01 0.30416158E+01 0.73720000E+00 0.92237114E+01 0.30761029E+01 0.30734477E+01 0.30741607E+01 0.73740000E+00 0.92963472E+01 0.31003416E+01 0.30976728E+01 0.30983328E+01 0.73760000E+00 0.93429800E+01 0.31159083E+01 0.31132342E+01 0.31138375E+01 0.73780000E+00 0.93632288E+01 0.31226755E+01 0.31200047E+01 0.31205486E+01 0.73800000E+00 0.93572374E+01 0.31206908E+01 0.31180318E+01 0.31185148E+01 0.73820000E+00 0.93256694E+01 0.31101753E+01 0.31075363E+01 0.31079578E+01 0.73840000E+00 0.92696784E+01 0.30915135E+01 0.30889022E+01 0.30892627E+01 0.73860000E+00 0.91908577E+01 0.30652363E+01 0.30626603E+01 0.30629611E+01 0.73880000E+00 0.90911713E+01 0.30319987E+01 0.30294645E+01 0.30297080E+01 0.73900000E+00 0.89728729E+01 0.29925522E+01 0.29900658E+01 0.29902549E+01 0.73920000E+00 0.88384192E+01 0.29477158E+01 0.29452827E+01 0.29454207E+01 0.73940000E+00 0.86903824E+01 0.28983476E+01 0.28959720E+01 0.28960628E+01 0.73960000E+00 0.85313671E+01 0.28453160E+01 0.28430017E+01 0.28430493E+01 0.73980000E+00 0.83639361E+01 0.27894760E+01 0.27872258E+01 0.27872342E+01 0.74000000E+00 0.81905475E+01 0.27316474E+01 0.27294635E+01 0.27294366E+01 0.74020000E+00 0.80135042E+01 0.26725983E+01 0.26704821E+01 0.26704238E+01 0.74040000E+00 0.78349162E+01 0.26130325E+01 0.26109849E+01 0.26108988E+01 0.74060000E+00 0.76566752E+01 0.25535812E+01 0.25516022E+01 0.25514918E+01 0.74080000E+00 0.74804398E+01 0.24947976E+01 0.24928870E+01 0.24927552E+01 0.74100000E+00 0.73076298E+01 0.24371554E+01 0.24353124E+01 0.24351620E+01 0.74120000E+00 0.71394279E+01 0.23810492E+01 0.23792726E+01 0.23791061E+01 0.74140000E+00 0.69767860E+01 0.23267965E+01 0.23250850E+01 0.23249045E+01 0.74160000E+00 0.68204364E+01 0.22746419E+01 0.22729935E+01 0.22728010E+01 0.74180000E+00 0.66709043E+01 0.22247605E+01 0.22231733E+01 0.22229706E+01 0.74200000E+00 0.65285220E+01 0.21772633E+01 0.21757351E+01 0.21755237E+01 0.74220000E+00 0.63934437E+01 0.21322018E+01 0.21307303E+01 0.21305116E+01 0.74240000E+00 0.62656598E+01 0.20895730E+01 0.20881557E+01 0.20879311E+01 0.74260000E+00 0.61450121E+01 0.20493242E+01 0.20479587E+01 0.20477292E+01 0.74280000E+00 0.60312079E+01 0.20113579E+01 0.20100415E+01 0.20098085E+01 0.74300000E+00 0.59238346E+01 0.19755366E+01 0.19742667E+01 0.19740312E+01 0.74320000E+00 0.58223753E+01 0.19416881E+01 0.19404621E+01 0.19402252E+01 0.74340000E+00 0.57262244E+01 0.19096103E+01 0.19084256E+01 0.19081885E+01 0.74360000E+00 0.56347054E+01 0.18790779E+01 0.18779319E+01 0.18776956E+01 0.74380000E+00 0.55470898E+01 0.18498479E+01 0.18487381E+01 0.18485038E+01 0.74400000E+00 0.54626174E+01 0.18216668E+01 0.18205909E+01 0.18203597E+01 0.74420000E+00 0.53805190E+01 0.17942783E+01 0.17932338E+01 0.17930068E+01 0.74440000E+00 0.53000393E+01 0.17674305E+01 0.17664153E+01 0.17661935E+01 0.74460000E+00 0.52204611E+01 0.17408842E+01 0.17398962E+01 0.17396807E+01 0.74480000E+00 0.51411274E+01 0.17144203E+01 0.17134578E+01 0.17132493E+01 0.74500000E+00 0.50614637E+01 0.16878473E+01 0.16869085E+01 0.16867079E+01 0.74520000E+00 0.49809953E+01 0.16610068E+01 0.16600903E+01 0.16598981E+01 0.74540000E+00 0.48993618E+01 0.16337787E+01 0.16328832E+01 0.16326999E+01 0.74560000E+00 0.48163255E+01 0.16060836E+01 0.16052081E+01 0.16050338E+01 0.74580000E+00 0.47317745E+01 0.15778841E+01 0.15770277E+01 0.15768627E+01 0.74600000E+00 0.46457199E+01 0.15491839E+01 0.15483460E+01 0.15481900E+01 0.74620000E+00 0.45582875E+01 0.15200249E+01 0.15192049E+01 0.15190577E+01 0.74640000E+00 0.44697048E+01 0.14904829E+01 0.14896804E+01 0.14895416E+01 0.74660000E+00 0.43802844E+01 0.14606620E+01 0.14598767E+01 0.14597457E+01 0.74680000E+00 0.42904051E+01 0.14306884E+01 0.14299203E+01 0.14297964E+01 0.74700000E+00 0.42004927E+01 0.14007042E+01 0.13999530E+01 0.13998355E+01 0.74720000E+00 0.41110002E+01 0.13708603E+01 0.13701259E+01 0.13700140E+01 0.74740000E+00 0.40223909E+01 0.13413111E+01 0.13405935E+01 0.13404863E+01 0.74760000E+00 0.39351219E+01 0.13122091E+01 0.13115081E+01 0.13114048E+01 0.74780000E+00 0.38496326E+01 0.12837006E+01 0.12830161E+01 0.12829159E+01 0.74800000E+00 0.37663336E+01 0.12559227E+01 0.12552544E+01 0.12551565E+01 0.74820000E+00 0.36856010E+01 0.12290006E+01 0.12283484E+01 0.12282520E+01 0.74840000E+00 0.36077713E+01 0.12030466E+01 0.12024101E+01 0.12023146E+01 0.74860000E+00 0.35331400E+01 0.11781591E+01 0.11775381E+01 0.11774427E+01 0.74880000E+00 0.34619612E+01 0.11544229E+01 0.11538171E+01 0.11537212E+01 0.74900000E+00 0.33944494E+01 0.11319096E+01 0.11313184E+01 0.11312215E+01 0.74920000E+00 0.33307819E+01 0.11106781E+01 0.11101012E+01 0.11100027E+01 0.74940000E+00 0.32711019E+01 0.10907762E+01 0.10902131E+01 0.10901126E+01 0.74960000E+00 0.32155222E+01 0.10722416E+01 0.10716918E+01 0.10715888E+01 0.74980000E+00 0.31641289E+01 0.10551030E+01 0.10545659E+01 0.10544600E+01 0.75000000E+00 0.31169851E+01 0.10393813E+01 0.10388565E+01 0.10387472E+01 0.75020000E+00 0.30741342E+01 0.10250911E+01 0.10245780E+01 0.10244650E+01 0.75040000E+00 0.30356028E+01 0.10122412E+01 0.10117393E+01 0.10116222E+01 0.75060000E+00 0.30014034E+01 0.10008358E+01 0.10003446E+01 0.10002230E+01 0.75080000E+00 0.29715366E+01 0.99087508E+00 0.99039392E+00 0.99026757E+00 0.75100000E+00 0.29459922E+01 0.98235564E+00 0.98188404E+00 0.98175251E+00 0.75120000E+00 0.29247506E+01 0.97527094E+00 0.97480840E+00 0.97467131E+00 0.75140000E+00 0.29077831E+01 0.96961138E+00 0.96915740E+00 0.96901437E+00 0.75160000E+00 0.28950515E+01 0.96536423E+00 0.96491835E+00 0.96476894E+00 0.75180000E+00 0.28865074E+01 0.96251336E+00 0.96207514E+00 0.96191890E+00 0.75200000E+00 0.28820908E+01 0.96103877E+00 0.96060781E+00 0.96044426E+00 0.75220000E+00 0.28817283E+01 0.96091594E+00 0.96049188E+00 0.96032047E+00 0.75240000E+00 0.28853299E+01 0.96211490E+00 0.96169743E+00 0.96151759E+00 0.75260000E+00 0.28927864E+01 0.96459919E+00 0.96418805E+00 0.96399913E+00 0.75280000E+00 0.29039650E+01 0.96832458E+00 0.96791958E+00 0.96772088E+00 0.75300000E+00 0.29187056E+01 0.97323761E+00 0.97283863E+00 0.97262936E+00 0.75320000E+00 0.29368154E+01 0.97927403E+00 0.97888101E+00 0.97866033E+00 0.75340000E+00 0.29580641E+01 0.98635704E+00 0.98597004E+00 0.98573699E+00 0.75360000E+00 0.29821787E+01 0.99439561E+00 0.99401478E+00 0.99376834E+00 0.75380000E+00 0.30088384E+01 0.10032827E+01 0.10029083E+01 0.10026474E+01 0.75400000E+00 0.30376697E+01 0.10128939E+01 0.10125262E+01 0.10122496E+01 0.75420000E+00 0.30682423E+01 0.10230856E+01 0.10227252E+01 0.10224316E+01 0.75440000E+00 0.31000670E+01 0.10336947E+01 0.10333421E+01 0.10330302E+01 0.75460000E+00 0.31325941E+01 0.10445379E+01 0.10441939E+01 0.10438622E+01 0.75480000E+00 0.31652151E+01 0.10554124E+01 0.10550778E+01 0.10547249E+01 0.75500000E+00 0.31972668E+01 0.10660970E+01 0.10657726E+01 0.10653972E+01 0.75520000E+00 0.32280387E+01 0.10763547E+01 0.10760417E+01 0.10756423E+01 0.75540000E+00 0.32567842E+01 0.10859367E+01 0.10856361E+01 0.10852115E+01 0.75560000E+00 0.32827354E+01 0.10945869E+01 0.10942997E+01 0.10938488E+01 0.75580000E+00 0.33051214E+01 0.11020483E+01 0.11017757E+01 0.11012975E+01 0.75600000E+00 0.33231904E+01 0.11080702E+01 0.11078131E+01 0.11073071E+01 0.75620000E+00 0.33362326E+01 0.11124160E+01 0.11121754E+01 0.11116412E+01 0.75640000E+00 0.33436055E+01 0.11148715E+01 0.11146482E+01 0.11140859E+01 0.75660000E+00 0.33447581E+01 0.11152529E+01 0.11150475E+01 0.11144577E+01 0.75680000E+00 0.33392521E+01 0.11134143E+01 0.11132270E+01 0.11126107E+01 0.75700000E+00 0.33267806E+01 0.11092533E+01 0.11090843E+01 0.11084430E+01 0.75720000E+00 0.33071803E+01 0.11027154E+01 0.11025647E+01 0.11019003E+01 0.75740000E+00 0.32804377E+01 0.10937962E+01 0.10936633E+01 0.10929782E+01 0.75760000E+00 0.32466882E+01 0.10825409E+01 0.10824251E+01 0.10817222E+01 0.75780000E+00 0.32062081E+01 0.10690416E+01 0.10689422E+01 0.10682243E+01 0.75800000E+00 0.31594011E+01 0.10534330E+01 0.10533487E+01 0.10526194E+01 0.75820000E+00 0.31067785E+01 0.10358855E+01 0.10358152E+01 0.10350778E+01 0.75840000E+00 0.30489371E+01 0.10165983E+01 0.10165404E+01 0.10157985E+01 0.75860000E+00 0.29865346E+01 0.99579036E+00 0.99574362E+00 0.99500058E+00 0.75880000E+00 0.29202644E+01 0.97369316E+00 0.97365605E+00 0.97291521E+00 0.75900000E+00 0.28508330E+01 0.95054214E+00 0.95051320E+00 0.94977770E+00 0.75920000E+00 0.27789385E+01 0.92657004E+00 0.92654786E+00 0.92582056E+00 0.75940000E+00 0.27052527E+01 0.90200089E+00 0.90198414E+00 0.90126763E+00 0.75960000E+00 0.26304074E+01 0.87704532E+00 0.87703276E+00 0.87632931E+00 0.75980000E+00 0.25549838E+01 0.85189707E+00 0.85188758E+00 0.85119913E+00 0.76000000E+00 0.24795056E+01 0.82673077E+00 0.82672334E+00 0.82605151E+00 0.76020000E+00 0.24044356E+01 0.80170067E+00 0.80169442E+00 0.80104051E+00 0.76040000E+00 0.23301744E+01 0.77694034E+00 0.77693452E+00 0.77629953E+00 0.76060000E+00 0.22570620E+01 0.75256313E+00 0.75255710E+00 0.75194176E+00 0.76080000E+00 0.21853805E+01 0.72866310E+00 0.72865631E+00 0.72806111E+00 0.76100000E+00 0.21153583E+01 0.70531636E+00 0.70530839E+00 0.70473359E+00 0.76120000E+00 0.20471748E+01 0.68258269E+00 0.68257320E+00 0.68201887E+00 0.76140000E+00 0.19809653E+01 0.66050727E+00 0.66049599E+00 0.65996205E+00 0.76160000E+00 0.19168269E+01 0.63912239E+00 0.63910914E+00 0.63859536E+00 0.76180000E+00 0.18548230E+01 0.61844922E+00 0.61843386E+00 0.61793990E+00 0.76200000E+00 0.17949885E+01 0.59849938E+00 0.59848183E+00 0.59800726E+00 0.76220000E+00 0.17373342E+01 0.57927649E+00 0.57925671E+00 0.57880103E+00 0.76240000E+00 0.16818512E+01 0.56077751E+00 0.56075551E+00 0.56031815E+00 0.76260000E+00 0.16285139E+01 0.54299399E+00 0.54296978E+00 0.54255016E+00 0.76280000E+00 0.15772841E+01 0.52591313E+00 0.52588676E+00 0.52548425E+00 0.76300000E+00 0.15281131E+01 0.50951870E+00 0.50949023E+00 0.50910420E+00 0.76320000E+00 0.14809445E+01 0.49379188E+00 0.49376140E+00 0.49339120E+00 0.76340000E+00 0.14357160E+01 0.47871193E+00 0.47867953E+00 0.47832451E+00 0.76360000E+00 0.13923613E+01 0.46425673E+00 0.46422251E+00 0.46388203E+00 0.76380000E+00 0.13508115E+01 0.45040333E+00 0.45036738E+00 0.45004082E+00 0.76400000E+00 0.13109964E+01 0.43712827E+00 0.43709069E+00 0.43677743E+00 0.76420000E+00 0.12728451E+01 0.42440794E+00 0.42436884E+00 0.42406828E+00 0.76440000E+00 0.12362870E+01 0.41221884E+00 0.41217831E+00 0.41188988E+00 0.76460000E+00 0.12012527E+01 0.40053775E+00 0.40049591E+00 0.40021904E+00 0.76480000E+00 0.11676739E+01 0.38934195E+00 0.38929888E+00 0.38903304E+00 0.76500000E+00 0.11354841E+01 0.37860927E+00 0.37856508E+00 0.37830975E+00 0.76520000E+00 0.11046190E+01 0.36831824E+00 0.36827302E+00 0.36802770E+00 0.76540000E+00 0.10750163E+01 0.35844813E+00 0.35840197E+00 0.35816619E+00 0.76560000E+00 0.10466162E+01 0.34897898E+00 0.34893195E+00 0.34870527E+00 0.76580000E+00 0.10193613E+01 0.33989164E+00 0.33984384E+00 0.33962582E+00 0.76600000E+00 0.99319659E+00 0.33116779E+00 0.33111928E+00 0.33090952E+00 0.76620000E+00 0.96806961E+00 0.32278992E+00 0.32274079E+00 0.32253890E+00 0.76640000E+00 0.94393027E+00 0.31474135E+00 0.31469166E+00 0.31449727E+00 0.76660000E+00 0.92073093E+00 0.30700619E+00 0.30695599E+00 0.30676875E+00 0.76680000E+00 0.89842624E+00 0.29956931E+00 0.29951868E+00 0.29933825E+00 0.76700000E+00 0.87697315E+00 0.29241636E+00 0.29236535E+00 0.29219143E+00 0.76720000E+00 0.85633076E+00 0.28553372E+00 0.28548238E+00 0.28531466E+00 0.76740000E+00 0.83646032E+00 0.27890845E+00 0.27885683E+00 0.27869503E+00 0.76760000E+00 0.81732503E+00 0.27252829E+00 0.27247645E+00 0.27232030E+00 0.76780000E+00 0.79889007E+00 0.26638163E+00 0.26632960E+00 0.26617884E+00 0.76800000E+00 0.78112242E+00 0.26045746E+00 0.26040528E+00 0.26025968E+00 0.76820000E+00 0.76399082E+00 0.25474536E+00 0.25469307E+00 0.25455239E+00 0.76840000E+00 0.74746565E+00 0.24923545E+00 0.24918308E+00 0.24904712E+00 0.76860000E+00 0.73151887E+00 0.24391838E+00 0.24386597E+00 0.24373451E+00 0.76880000E+00 0.71612393E+00 0.23878531E+00 0.23873289E+00 0.23860573E+00 0.76900000E+00 0.70125570E+00 0.23382785E+00 0.23377544E+00 0.23365241E+00 0.76920000E+00 0.68689035E+00 0.22903805E+00 0.22898569E+00 0.22886660E+00 0.76940000E+00 0.67300535E+00 0.22440842E+00 0.22435612E+00 0.22424081E+00 0.76960000E+00 0.65957931E+00 0.21993180E+00 0.21987960E+00 0.21976791E+00 0.76980000E+00 0.64659201E+00 0.21560148E+00 0.21554938E+00 0.21544116E+00 0.77000000E+00 0.63402426E+00 0.21141103E+00 0.21135907E+00 0.21125417E+00 0.77020000E+00 0.62185789E+00 0.20735441E+00 0.20730259E+00 0.20720088E+00 0.77040000E+00 0.61007564E+00 0.20342587E+00 0.20337421E+00 0.20327556E+00 0.77060000E+00 0.59866117E+00 0.19961994E+00 0.19956846E+00 0.19947276E+00 0.77080000E+00 0.58759896E+00 0.19593147E+00 0.19588019E+00 0.19578730E+00 0.77100000E+00 0.57687430E+00 0.19235555E+00 0.19230446E+00 0.19221429E+00 0.77120000E+00 0.56647321E+00 0.18888751E+00 0.18883664E+00 0.18874907E+00 0.77140000E+00 0.55638242E+00 0.18552292E+00 0.18547228E+00 0.18538721E+00 0.77160000E+00 0.54658931E+00 0.18225760E+00 0.18220719E+00 0.18212453E+00 0.77180000E+00 0.53708191E+00 0.17908753E+00 0.17903736E+00 0.17895702E+00 0.77200000E+00 0.52784883E+00 0.17600892E+00 0.17595901E+00 0.17588090E+00 0.77220000E+00 0.51887924E+00 0.17301817E+00 0.17296852E+00 0.17289255E+00 0.77240000E+00 0.51016281E+00 0.17011183E+00 0.17006244E+00 0.16998854E+00 0.77260000E+00 0.50168976E+00 0.16728664E+00 0.16723752E+00 0.16716561E+00 0.77280000E+00 0.49345074E+00 0.16453947E+00 0.16449063E+00 0.16442064E+00 0.77300000E+00 0.48543684E+00 0.16186737E+00 0.16181881E+00 0.16175067E+00 0.77320000E+00 0.47763961E+00 0.15926750E+00 0.15921923E+00 0.15915287E+00 0.77340000E+00 0.47005095E+00 0.15673718E+00 0.15668920E+00 0.15662456E+00 0.77360000E+00 0.46266316E+00 0.15427384E+00 0.15422615E+00 0.15416317E+00 0.77380000E+00 0.45546890E+00 0.15187502E+00 0.15182763E+00 0.15176625E+00 0.77400000E+00 0.44846114E+00 0.14953839E+00 0.14949129E+00 0.14943146E+00 0.77420000E+00 0.44163320E+00 0.14726171E+00 0.14721491E+00 0.14715658E+00 0.77440000E+00 0.43497868E+00 0.14504285E+00 0.14499636E+00 0.14493947E+00 0.77460000E+00 0.42849147E+00 0.14287978E+00 0.14283359E+00 0.14277810E+00 0.77480000E+00 0.42216572E+00 0.14077055E+00 0.14072466E+00 0.14067052E+00 0.77500000E+00 0.41599586E+00 0.13871329E+00 0.13866771E+00 0.13861487E+00 0.77520000E+00 0.40997655E+00 0.13670623E+00 0.13666095E+00 0.13660937E+00 0.77540000E+00 0.40410267E+00 0.13474766E+00 0.13470268E+00 0.13465233E+00 0.77560000E+00 0.39836934E+00 0.13283595E+00 0.13279128E+00 0.13274211E+00 0.77580000E+00 0.39277187E+00 0.13096954E+00 0.13092518E+00 0.13087715E+00 0.77600000E+00 0.38730577E+00 0.12914693E+00 0.12910288E+00 0.12905596E+00 0.77620000E+00 0.38196674E+00 0.12736670E+00 0.12732295E+00 0.12727710E+00 0.77640000E+00 0.37675067E+00 0.12562746E+00 0.12558401E+00 0.12553921E+00 0.77660000E+00 0.37165360E+00 0.12392789E+00 0.12388475E+00 0.12384096E+00 0.77680000E+00 0.36667175E+00 0.12226675E+00 0.12222391E+00 0.12218109E+00 0.77700000E+00 0.36180147E+00 0.12064280E+00 0.12060027E+00 0.12055840E+00 0.77720000E+00 0.35703927E+00 0.11905490E+00 0.11901266E+00 0.11897171E+00 0.77740000E+00 0.35238180E+00 0.11750191E+00 0.11745997E+00 0.11741991E+00 0.77760000E+00 0.34782584E+00 0.11598277E+00 0.11594113E+00 0.11590194E+00 0.77780000E+00 0.34336829E+00 0.11449644E+00 0.11445510E+00 0.11441675E+00 0.77800000E+00 0.33900619E+00 0.11304194E+00 0.11300089E+00 0.11296336E+00 0.77820000E+00 0.33473667E+00 0.11161831E+00 0.11157755E+00 0.11154081E+00 0.77840000E+00 0.33055697E+00 0.11022462E+00 0.11018416E+00 0.11014819E+00 0.77860000E+00 0.32646446E+00 0.10886001E+00 0.10881984E+00 0.10878461E+00 0.77880000E+00 0.32245659E+00 0.10752362E+00 0.10748373E+00 0.10744924E+00 0.77900000E+00 0.31853090E+00 0.10621463E+00 0.10617503E+00 0.10614124E+00 0.77920000E+00 0.31468504E+00 0.10493226E+00 0.10489294E+00 0.10485984E+00 0.77940000E+00 0.31091673E+00 0.10367574E+00 0.10363671E+00 0.10360427E+00 0.77960000E+00 0.30722377E+00 0.10244435E+00 0.10240560E+00 0.10237382E+00 0.77980000E+00 0.30360406E+00 0.10123739E+00 0.10119891E+00 0.10116776E+00 0.78000000E+00 0.30005556E+00 0.10005416E+00 0.10001597E+00 0.99985429E-01 0.78020000E+00 0.29657631E+00 0.98894030E-01 0.98856108E-01 0.98826167E-01 0.78040000E+00 0.29316440E+00 0.97756352E-01 0.97718703E-01 0.97689345E-01 0.78060000E+00 0.28981802E+00 0.96640521E-01 0.96603143E-01 0.96574351E-01 0.78080000E+00 0.28653539E+00 0.95545949E-01 0.95508839E-01 0.95480600E-01 0.78100000E+00 0.28331481E+00 0.94472068E-01 0.94435224E-01 0.94407523E-01 0.78120000E+00 0.28015465E+00 0.93418329E-01 0.93381748E-01 0.93354571E-01 0.78140000E+00 0.27705330E+00 0.92384201E-01 0.92347883E-01 0.92321217E-01 0.78160000E+00 0.27400924E+00 0.91369174E-01 0.91333115E-01 0.91306947E-01 0.78180000E+00 0.27102097E+00 0.90372752E-01 0.90336950E-01 0.90311267E-01 0.78200000E+00 0.26808707E+00 0.89394456E-01 0.89358910E-01 0.89333700E-01 0.78220000E+00 0.26520614E+00 0.88433825E-01 0.88398531E-01 0.88373782E-01 0.78240000E+00 0.26237684E+00 0.87490409E-01 0.87455367E-01 0.87431068E-01 0.78260000E+00 0.25959789E+00 0.86563778E-01 0.86528985E-01 0.86505124E-01 0.78280000E+00 0.25686801E+00 0.85653511E-01 0.85618964E-01 0.85595532E-01 0.78300000E+00 0.25418599E+00 0.84759204E-01 0.84724901E-01 0.84701886E-01 0.78320000E+00 0.25155066E+00 0.83880462E-01 0.83846402E-01 0.83823795E-01 0.78340000E+00 0.24896087E+00 0.83016908E-01 0.82983088E-01 0.82960878E-01 0.78360000E+00 0.24641553E+00 0.82168171E-01 0.82134589E-01 0.82112767E-01 0.78380000E+00 0.24391355E+00 0.81333896E-01 0.81300550E-01 0.81279107E-01 0.78400000E+00 0.24145391E+00 0.80513737E-01 0.80480624E-01 0.80459552E-01 0.78420000E+00 0.23903560E+00 0.79707358E-01 0.79674477E-01 0.79653766E-01 0.78440000E+00 0.23665765E+00 0.78914435E-01 0.78881784E-01 0.78861426E-01 0.78460000E+00 0.23431910E+00 0.78134653E-01 0.78102229E-01 0.78082216E-01 0.78480000E+00 0.23201905E+00 0.77367707E-01 0.77335508E-01 0.77315832E-01 0.78500000E+00 0.22975660E+00 0.76613299E-01 0.76581323E-01 0.76561977E-01 0.78520000E+00 0.22753090E+00 0.75871143E-01 0.75839388E-01 0.75820364E-01 0.78540000E+00 0.22534110E+00 0.75140959E-01 0.75109424E-01 0.75090714E-01 0.78560000E+00 0.22318639E+00 0.74422477E-01 0.74391158E-01 0.74372757E-01 0.78580000E+00 0.22106599E+00 0.73715433E-01 0.73684329E-01 0.73666229E-01 0.78600000E+00 0.21897913E+00 0.73019572E-01 0.72988682E-01 0.72970875E-01 0.78620000E+00 0.21692506E+00 0.72334646E-01 0.72303967E-01 0.72286448E-01 0.78640000E+00 0.21490307E+00 0.71660415E-01 0.71629945E-01 0.71612708E-01 0.78660000E+00 0.21291244E+00 0.70996643E-01 0.70966380E-01 0.70949419E-01 0.78680000E+00 0.21095250E+00 0.70343104E-01 0.70313046E-01 0.70296354E-01 0.78700000E+00 0.20902259E+00 0.69699577E-01 0.69669722E-01 0.69653294E-01 0.78720000E+00 0.20712206E+00 0.69065845E-01 0.69036192E-01 0.69020022E-01 0.78740000E+00 0.20525028E+00 0.68441701E-01 0.68412247E-01 0.68396330E-01 0.78760000E+00 0.20340664E+00 0.67826941E-01 0.67797685E-01 0.67782015E-01 0.78780000E+00 0.20159055E+00 0.67221367E-01 0.67192307E-01 0.67176879E-01 0.78800000E+00 0.19980144E+00 0.66624788E-01 0.66595921E-01 0.66580730E-01 0.78820000E+00 0.19803874E+00 0.66037014E-01 0.66008340E-01 0.65993382E-01 0.78840000E+00 0.19630190E+00 0.65457866E-01 0.65429381E-01 0.65414651E-01 0.78860000E+00 0.19459039E+00 0.64887164E-01 0.64858869E-01 0.64844361E-01 0.78880000E+00 0.19290371E+00 0.64324738E-01 0.64296629E-01 0.64282339E-01 0.78900000E+00 0.19124133E+00 0.63770417E-01 0.63742493E-01 0.63728417E-01 0.78920000E+00 0.18960277E+00 0.63224040E-01 0.63196299E-01 0.63182433E-01 0.78940000E+00 0.18798756E+00 0.62685446E-01 0.62657887E-01 0.62644226E-01 0.78960000E+00 0.18639522E+00 0.62154480E-01 0.62127100E-01 0.62113641E-01 0.78980000E+00 0.18482531E+00 0.61630991E-01 0.61603790E-01 0.61590528E-01 0.79000000E+00 0.18327738E+00 0.61114832E-01 0.61087806E-01 0.61074738E-01 0.79020000E+00 0.18175099E+00 0.60605858E-01 0.60579007E-01 0.60566128E-01 0.79040000E+00 0.18024574E+00 0.60103929E-01 0.60077252E-01 0.60064559E-01 0.79060000E+00 0.17876121E+00 0.59608910E-01 0.59582404E-01 0.59569894E-01 0.79080000E+00 0.17729700E+00 0.59120667E-01 0.59094331E-01 0.59081999E-01 0.79100000E+00 0.17585272E+00 0.58639069E-01 0.58612902E-01 0.58600746E-01 0.79120000E+00 0.17442799E+00 0.58163992E-01 0.58137991E-01 0.58126007E-01 0.79140000E+00 0.17302244E+00 0.57695310E-01 0.57669474E-01 0.57657659E-01 0.79160000E+00 0.17163572E+00 0.57232903E-01 0.57207231E-01 0.57195582E-01 0.79180000E+00 0.17026746E+00 0.56776654E-01 0.56751145E-01 0.56739658E-01 0.79200000E+00 0.16891732E+00 0.56326449E-01 0.56301100E-01 0.56289772E-01 0.79220000E+00 0.16758497E+00 0.55882174E-01 0.55856984E-01 0.55845813E-01 0.79240000E+00 0.16627008E+00 0.55443721E-01 0.55418689E-01 0.55407672E-01 0.79260000E+00 0.16497233E+00 0.55010984E-01 0.54986108E-01 0.54975241E-01 0.79280000E+00 0.16369141E+00 0.54583857E-01 0.54559135E-01 0.54548417E-01 0.79300000E+00 0.16242701E+00 0.54162239E-01 0.54137671E-01 0.54127098E-01 0.79320000E+00 0.16117883E+00 0.53746031E-01 0.53721615E-01 0.53711185E-01 0.79340000E+00 0.15994658E+00 0.53335135E-01 0.53310870E-01 0.53300580E-01 0.79360000E+00 0.15872999E+00 0.52929457E-01 0.52905341E-01 0.52895189E-01 0.79380000E+00 0.15752876E+00 0.52528904E-01 0.52504936E-01 0.52494919E-01 0.79400000E+00 0.15634263E+00 0.52133386E-01 0.52109564E-01 0.52099680E-01 0.79420000E+00 0.15517133E+00 0.51742814E-01 0.51719137E-01 0.51709383E-01 0.79440000E+00 0.15401461E+00 0.51357101E-01 0.51333568E-01 0.51323943E-01 0.79460000E+00 0.15287221E+00 0.50976164E-01 0.50952773E-01 0.50943274E-01 0.79480000E+00 0.15174388E+00 0.50599919E-01 0.50576669E-01 0.50567294E-01 0.79500000E+00 0.15062938E+00 0.50228285E-01 0.50205176E-01 0.50195922E-01 0.79520000E+00 0.14952848E+00 0.49861184E-01 0.49838214E-01 0.49829079E-01 0.79540000E+00 0.14844093E+00 0.49498539E-01 0.49475706E-01 0.49466689E-01 0.79560000E+00 0.14736652E+00 0.49140273E-01 0.49117576E-01 0.49108675E-01 0.79580000E+00 0.14630503E+00 0.48786314E-01 0.48763752E-01 0.48754964E-01 0.79600000E+00 0.14525623E+00 0.48436587E-01 0.48414159E-01 0.48405483E-01 0.79620000E+00 0.14421991E+00 0.48091024E-01 0.48068728E-01 0.48060162E-01 0.79640000E+00 0.14319588E+00 0.47749554E-01 0.47727390E-01 0.47718931E-01 0.79660000E+00 0.14218391E+00 0.47412110E-01 0.47390076E-01 0.47381723E-01 0.79680000E+00 0.14118382E+00 0.47078626E-01 0.47056721E-01 0.47048472E-01 0.79700000E+00 0.14019541E+00 0.46749036E-01 0.46727259E-01 0.46719113E-01 0.79720000E+00 0.13921849E+00 0.46423277E-01 0.46401627E-01 0.46393582E-01 0.79740000E+00 0.13825287E+00 0.46101287E-01 0.46079763E-01 0.46071816E-01 0.79760000E+00 0.13729837E+00 0.45783005E-01 0.45761605E-01 0.45753757E-01 0.79780000E+00 0.13635481E+00 0.45468371E-01 0.45447095E-01 0.45439343E-01 0.79800000E+00 0.13542202E+00 0.45157328E-01 0.45136174E-01 0.45128516E-01 0.79820000E+00 0.13449982E+00 0.44849817E-01 0.44828784E-01 0.44821219E-01 0.79840000E+00 0.13358805E+00 0.44545782E-01 0.44524870E-01 0.44517396E-01 0.79860000E+00 0.13268654E+00 0.44245170E-01 0.44224377E-01 0.44216993E-01 0.79880000E+00 0.13179513E+00 0.43947926E-01 0.43927251E-01 0.43919955E-01 0.79900000E+00 0.13091367E+00 0.43653997E-01 0.43633439E-01 0.43626231E-01 0.79920000E+00 0.13004199E+00 0.43363331E-01 0.43342890E-01 0.43335767E-01 0.79940000E+00 0.12917995E+00 0.43075879E-01 0.43055553E-01 0.43048515E-01 0.79960000E+00 0.12832739E+00 0.42791590E-01 0.42771378E-01 0.42764423E-01 0.79980000E+00 0.12748418E+00 0.42510417E-01 0.42490318E-01 0.42483445E-01 0.80000000E+00 0.12665017E+00 0.42232310E-01 0.42212324E-01 0.42205531E-01 0.80020000E+00 0.12582521E+00 0.41957225E-01 0.41937349E-01 0.41930636E-01 0.80040000E+00 0.12500918E+00 0.41685114E-01 0.41665348E-01 0.41658713E-01 0.80060000E+00 0.12420193E+00 0.41415933E-01 0.41396277E-01 0.41389719E-01 0.80080000E+00 0.12340334E+00 0.41149638E-01 0.41130090E-01 0.41123608E-01 0.80100000E+00 0.12261327E+00 0.40886185E-01 0.40866745E-01 0.40860337E-01 0.80120000E+00 0.12183160E+00 0.40625533E-01 0.40606200E-01 0.40599865E-01 0.80140000E+00 0.12105820E+00 0.40367640E-01 0.40348412E-01 0.40342150E-01 0.80160000E+00 0.12029296E+00 0.40112465E-01 0.40093342E-01 0.40087151E-01 0.80180000E+00 0.11953575E+00 0.39859968E-01 0.39840949E-01 0.39834828E-01 0.80200000E+00 0.11878645E+00 0.39610110E-01 0.39591194E-01 0.39585142E-01 0.80220000E+00 0.11804495E+00 0.39362852E-01 0.39344039E-01 0.39338055E-01 0.80240000E+00 0.11731113E+00 0.39118157E-01 0.39099445E-01 0.39093528E-01 0.80260000E+00 0.11658489E+00 0.38875988E-01 0.38857376E-01 0.38851526E-01 0.80280000E+00 0.11586611E+00 0.38636308E-01 0.38617796E-01 0.38612010E-01 0.80300000E+00 0.11515470E+00 0.38399081E-01 0.38380668E-01 0.38374947E-01 0.80320000E+00 0.11445053E+00 0.38164273E-01 0.38145958E-01 0.38140300E-01 0.80340000E+00 0.11375351E+00 0.37931849E-01 0.37913631E-01 0.37908035E-01 0.80360000E+00 0.11306355E+00 0.37701775E-01 0.37683654E-01 0.37678120E-01 0.80380000E+00 0.11238053E+00 0.37474019E-01 0.37455993E-01 0.37450519E-01 0.80400000E+00 0.11170436E+00 0.37248547E-01 0.37230616E-01 0.37225202E-01 0.80420000E+00 0.11103495E+00 0.37025328E-01 0.37007491E-01 0.37002136E-01 0.80440000E+00 0.11037221E+00 0.36804330E-01 0.36786586E-01 0.36781289E-01 0.80460000E+00 0.10971603E+00 0.36585522E-01 0.36567872E-01 0.36562632E-01 0.80480000E+00 0.10906632E+00 0.36368875E-01 0.36351316E-01 0.36346133E-01 0.80500000E+00 0.10842301E+00 0.36154359E-01 0.36136891E-01 0.36131763E-01 0.80520000E+00 0.10778600E+00 0.35941943E-01 0.35924566E-01 0.35919492E-01 0.80540000E+00 0.10715521E+00 0.35731600E-01 0.35714312E-01 0.35709293E-01 0.80560000E+00 0.10653054E+00 0.35523301E-01 0.35506102E-01 0.35501137E-01 0.80580000E+00 0.10591192E+00 0.35317019E-01 0.35299909E-01 0.35294995E-01 0.80600000E+00 0.10529927E+00 0.35112727E-01 0.35095704E-01 0.35090842E-01 0.80620000E+00 0.10469251E+00 0.34910397E-01 0.34893460E-01 0.34888650E-01 0.80640000E+00 0.10409155E+00 0.34710003E-01 0.34693153E-01 0.34688393E-01 0.80660000E+00 0.10349632E+00 0.34511520E-01 0.34494755E-01 0.34490045E-01 0.80680000E+00 0.10290675E+00 0.34314922E-01 0.34298242E-01 0.34293581E-01 0.80700000E+00 0.10232275E+00 0.34120184E-01 0.34103588E-01 0.34098976E-01 0.80720000E+00 0.10174426E+00 0.33927282E-01 0.33910770E-01 0.33906205E-01 0.80740000E+00 0.10117120E+00 0.33736192E-01 0.33719762E-01 0.33715244E-01 0.80760000E+00 0.10060350E+00 0.33546889E-01 0.33530541E-01 0.33526069E-01 0.80780000E+00 0.10004109E+00 0.33359350E-01 0.33343084E-01 0.33338658E-01 0.80800000E+00 0.99483909E-01 0.33173554E-01 0.33157368E-01 0.33152988E-01 0.80820000E+00 0.98931881E-01 0.32989476E-01 0.32973371E-01 0.32969035E-01 0.80840000E+00 0.98384941E-01 0.32807095E-01 0.32791069E-01 0.32786777E-01 0.80860000E+00 0.97843024E-01 0.32626389E-01 0.32610442E-01 0.32606194E-01 0.80880000E+00 0.97306067E-01 0.32447336E-01 0.32431468E-01 0.32427262E-01 0.80900000E+00 0.96774005E-01 0.32269916E-01 0.32254126E-01 0.32249963E-01 0.80920000E+00 0.96246776E-01 0.32094108E-01 0.32078395E-01 0.32074273E-01 0.80940000E+00 0.95724320E-01 0.31919891E-01 0.31904255E-01 0.31900174E-01 0.80960000E+00 0.95206576E-01 0.31747245E-01 0.31731685E-01 0.31727645E-01 0.80980000E+00 0.94693484E-01 0.31576151E-01 0.31560666E-01 0.31556667E-01 0.81000000E+00 0.94184988E-01 0.31406589E-01 0.31391179E-01 0.31387219E-01 0.81020000E+00 0.93681028E-01 0.31238540E-01 0.31223204E-01 0.31219284E-01 0.81040000E+00 0.93181549E-01 0.31071985E-01 0.31056723E-01 0.31052841E-01 0.81060000E+00 0.92686495E-01 0.30906906E-01 0.30891717E-01 0.30887873E-01 0.81080000E+00 0.92195812E-01 0.30743284E-01 0.30728167E-01 0.30724361E-01 0.81100000E+00 0.91709446E-01 0.30581101E-01 0.30566057E-01 0.30562288E-01 0.81120000E+00 0.91227343E-01 0.30420340E-01 0.30405368E-01 0.30401635E-01 0.81140000E+00 0.90749452E-01 0.30260984E-01 0.30246082E-01 0.30242386E-01 0.81160000E+00 0.90275722E-01 0.30103015E-01 0.30088184E-01 0.30084524E-01 0.81180000E+00 0.89806102E-01 0.29946416E-01 0.29931655E-01 0.29928030E-01 0.81200000E+00 0.89340542E-01 0.29791172E-01 0.29776480E-01 0.29772890E-01 0.81220000E+00 0.88878993E-01 0.29637265E-01 0.29622642E-01 0.29619087E-01 0.81240000E+00 0.88421408E-01 0.29484679E-01 0.29470125E-01 0.29466604E-01 0.81260000E+00 0.87967738E-01 0.29333400E-01 0.29318913E-01 0.29315425E-01 0.81280000E+00 0.87517938E-01 0.29183410E-01 0.29168991E-01 0.29165537E-01 0.81300000E+00 0.87071960E-01 0.29034695E-01 0.29020343E-01 0.29016922E-01 0.81320000E+00 0.86629760E-01 0.28887240E-01 0.28872955E-01 0.28869565E-01 0.81340000E+00 0.86191294E-01 0.28741030E-01 0.28726811E-01 0.28723453E-01 0.81360000E+00 0.85756517E-01 0.28596050E-01 0.28581896E-01 0.28578570E-01 0.81380000E+00 0.85325385E-01 0.28452286E-01 0.28438197E-01 0.28434903E-01 0.81400000E+00 0.84897858E-01 0.28309723E-01 0.28295699E-01 0.28292435E-01 0.81420000E+00 0.84473891E-01 0.28168348E-01 0.28154388E-01 0.28151155E-01 0.81440000E+00 0.84053445E-01 0.28028147E-01 0.28014250E-01 0.28011047E-01 0.81460000E+00 0.83636478E-01 0.27889106E-01 0.27875272E-01 0.27872099E-01 0.81480000E+00 0.83222950E-01 0.27751212E-01 0.27737441E-01 0.27734297E-01 0.81500000E+00 0.82812822E-01 0.27614451E-01 0.27600743E-01 0.27597628E-01 0.81520000E+00 0.82406055E-01 0.27478812E-01 0.27465165E-01 0.27462079E-01 0.81540000E+00 0.82002610E-01 0.27344279E-01 0.27330694E-01 0.27327637E-01 0.81560000E+00 0.81602450E-01 0.27210843E-01 0.27197318E-01 0.27194289E-01 0.81580000E+00 0.81205536E-01 0.27078489E-01 0.27065025E-01 0.27062023E-01 0.81600000E+00 0.80811834E-01 0.26947205E-01 0.26933801E-01 0.26930827E-01 0.81620000E+00 0.80421306E-01 0.26816980E-01 0.26803636E-01 0.26800689E-01 0.81640000E+00 0.80033916E-01 0.26687802E-01 0.26674517E-01 0.26671597E-01 0.81660000E+00 0.79649630E-01 0.26559659E-01 0.26546433E-01 0.26543539E-01 0.81680000E+00 0.79268413E-01 0.26432539E-01 0.26419371E-01 0.26416503E-01 0.81700000E+00 0.78890230E-01 0.26306431E-01 0.26293321E-01 0.26290479E-01 0.81720000E+00 0.78515049E-01 0.26181323E-01 0.26168271E-01 0.26165455E-01 0.81740000E+00 0.78142836E-01 0.26057206E-01 0.26044211E-01 0.26041419E-01 0.81760000E+00 0.77773557E-01 0.25934067E-01 0.25921128E-01 0.25918362E-01 0.81780000E+00 0.77407182E-01 0.25811896E-01 0.25799014E-01 0.25796272E-01 0.81800000E+00 0.77043677E-01 0.25690682E-01 0.25677856E-01 0.25675139E-01 0.81820000E+00 0.76683013E-01 0.25570415E-01 0.25557645E-01 0.25554952E-01 0.81840000E+00 0.76325157E-01 0.25451085E-01 0.25438370E-01 0.25435701E-01 0.81860000E+00 0.75970080E-01 0.25332682E-01 0.25320022E-01 0.25317376E-01 0.81880000E+00 0.75617750E-01 0.25215194E-01 0.25202589E-01 0.25199967E-01 0.81900000E+00 0.75268140E-01 0.25098614E-01 0.25086062E-01 0.25083463E-01 0.81920000E+00 0.74921219E-01 0.24982930E-01 0.24970432E-01 0.24967856E-01 0.81940000E+00 0.74576958E-01 0.24868133E-01 0.24855689E-01 0.24853136E-01 0.81960000E+00 0.74235329E-01 0.24754214E-01 0.24741823E-01 0.24739292E-01 0.81980000E+00 0.73896305E-01 0.24641164E-01 0.24628825E-01 0.24626316E-01 0.82000000E+00 0.73559857E-01 0.24528972E-01 0.24516686E-01 0.24514199E-01 0.82020000E+00 0.73225958E-01 0.24417631E-01 0.24405397E-01 0.24402931E-01 0.82040000E+00 0.72894581E-01 0.24307130E-01 0.24294948E-01 0.24292503E-01 0.82060000E+00 0.72565700E-01 0.24197462E-01 0.24185331E-01 0.24182907E-01 0.82080000E+00 0.72239289E-01 0.24088617E-01 0.24076537E-01 0.24074134E-01 0.82100000E+00 0.71915321E-01 0.23980587E-01 0.23968558E-01 0.23966176E-01 0.82120000E+00 0.71593771E-01 0.23873364E-01 0.23861384E-01 0.23859023E-01 0.82140000E+00 0.71274614E-01 0.23766938E-01 0.23755008E-01 0.23752667E-01 0.82160000E+00 0.70957825E-01 0.23661302E-01 0.23649422E-01 0.23647101E-01 0.82180000E+00 0.70643380E-01 0.23556448E-01 0.23544617E-01 0.23542315E-01 0.82200000E+00 0.70331254E-01 0.23452367E-01 0.23440585E-01 0.23438303E-01 0.82220000E+00 0.70021424E-01 0.23349051E-01 0.23337318E-01 0.23335055E-01 0.82240000E+00 0.69713866E-01 0.23246493E-01 0.23234808E-01 0.23232565E-01 0.82260000E+00 0.69408557E-01 0.23144685E-01 0.23133048E-01 0.23130824E-01 0.82280000E+00 0.69105474E-01 0.23043619E-01 0.23032030E-01 0.23029824E-01 0.82300000E+00 0.68804594E-01 0.22943288E-01 0.22931746E-01 0.22929559E-01 0.82320000E+00 0.68505895E-01 0.22843684E-01 0.22832190E-01 0.22830021E-01 0.82340000E+00 0.68209355E-01 0.22744801E-01 0.22733353E-01 0.22731202E-01 0.82360000E+00 0.67914953E-01 0.22646630E-01 0.22635228E-01 0.22633095E-01 0.82380000E+00 0.67622666E-01 0.22549164E-01 0.22537808E-01 0.22535694E-01 0.82400000E+00 0.67332474E-01 0.22452397E-01 0.22441087E-01 0.22438990E-01 0.82420000E+00 0.67044355E-01 0.22356321E-01 0.22345057E-01 0.22342977E-01 0.82440000E+00 0.66758289E-01 0.22260930E-01 0.22249711E-01 0.22247648E-01 0.82460000E+00 0.66474256E-01 0.22166216E-01 0.22155043E-01 0.22152997E-01 0.82480000E+00 0.66192235E-01 0.22072174E-01 0.22061045E-01 0.22059016E-01 0.82500000E+00 0.65912207E-01 0.21978796E-01 0.21967712E-01 0.21965700E-01 0.82520000E+00 0.65634152E-01 0.21886076E-01 0.21875036E-01 0.21873040E-01 0.82540000E+00 0.65358051E-01 0.21794008E-01 0.21783011E-01 0.21781032E-01 0.82560000E+00 0.65083884E-01 0.21702584E-01 0.21691631E-01 0.21689668E-01 0.82580000E+00 0.64811632E-01 0.21611799E-01 0.21600890E-01 0.21598943E-01 0.82600000E+00 0.64541277E-01 0.21521647E-01 0.21510780E-01 0.21508849E-01 0.82620000E+00 0.64272801E-01 0.21432121E-01 0.21421297E-01 0.21419382E-01 0.82640000E+00 0.64006185E-01 0.21343216E-01 0.21332434E-01 0.21330535E-01 0.82660000E+00 0.63741411E-01 0.21254925E-01 0.21244185E-01 0.21242301E-01 0.82680000E+00 0.63478462E-01 0.21167242E-01 0.21156545E-01 0.21154676E-01 0.82700000E+00 0.63217320E-01 0.21080162E-01 0.21069506E-01 0.21067652E-01 0.82720000E+00 0.62957968E-01 0.20993678E-01 0.20983064E-01 0.20981225E-01 0.82740000E+00 0.62700388E-01 0.20907786E-01 0.20897213E-01 0.20895389E-01 0.82760000E+00 0.62444564E-01 0.20822479E-01 0.20811947E-01 0.20810137E-01 0.82780000E+00 0.62190479E-01 0.20737752E-01 0.20727261E-01 0.20725466E-01 0.82800000E+00 0.61938116E-01 0.20653600E-01 0.20643149E-01 0.20641368E-01 0.82820000E+00 0.61687460E-01 0.20570016E-01 0.20559605E-01 0.20557839E-01 0.82840000E+00 0.61438494E-01 0.20486996E-01 0.20476625E-01 0.20474873E-01 0.82860000E+00 0.61191203E-01 0.20404535E-01 0.20394203E-01 0.20392465E-01 0.82880000E+00 0.60945570E-01 0.20322626E-01 0.20312334E-01 0.20310609E-01 0.82900000E+00 0.60701579E-01 0.20241265E-01 0.20231013E-01 0.20229301E-01 0.82920000E+00 0.60459217E-01 0.20160447E-01 0.20150234E-01 0.20148536E-01 0.82940000E+00 0.60218468E-01 0.20080167E-01 0.20069992E-01 0.20068308E-01 0.82960000E+00 0.59979316E-01 0.20000420E-01 0.19990283E-01 0.19988612E-01 0.82980000E+00 0.59741747E-01 0.19921200E-01 0.19911102E-01 0.19909444E-01 0.83000000E+00 0.59505746E-01 0.19842504E-01 0.19832444E-01 0.19830799E-01 0.83020000E+00 0.59271299E-01 0.19764325E-01 0.19754303E-01 0.19752671E-01 0.83040000E+00 0.59038391E-01 0.19686660E-01 0.19676675E-01 0.19675056E-01 0.83060000E+00 0.58807009E-01 0.19609504E-01 0.19599556E-01 0.19597950E-01 0.83080000E+00 0.58577139E-01 0.19532851E-01 0.19522941E-01 0.19521347E-01 0.83100000E+00 0.58348766E-01 0.19456698E-01 0.19446825E-01 0.19445243E-01 0.83120000E+00 0.58121878E-01 0.19381040E-01 0.19371204E-01 0.19369634E-01 0.83140000E+00 0.57896460E-01 0.19305873E-01 0.19296072E-01 0.19294515E-01 0.83160000E+00 0.57672500E-01 0.19231191E-01 0.19221427E-01 0.19219882E-01 0.83180000E+00 0.57449984E-01 0.19156991E-01 0.19147263E-01 0.19145730E-01 0.83200000E+00 0.57228899E-01 0.19083268E-01 0.19073576E-01 0.19072054E-01 0.83220000E+00 0.57009233E-01 0.19010019E-01 0.19000362E-01 0.18998852E-01 0.83240000E+00 0.56790972E-01 0.18937238E-01 0.18927616E-01 0.18926118E-01 0.83260000E+00 0.56574105E-01 0.18864921E-01 0.18855335E-01 0.18853848E-01 0.83280000E+00 0.56358618E-01 0.18793065E-01 0.18783514E-01 0.18782039E-01 0.83300000E+00 0.56144500E-01 0.18721666E-01 0.18712149E-01 0.18710685E-01 0.83320000E+00 0.55931738E-01 0.18650718E-01 0.18641237E-01 0.18639784E-01 0.83340000E+00 0.55720321E-01 0.18580219E-01 0.18570772E-01 0.18569330E-01 0.83360000E+00 0.55510237E-01 0.18510165E-01 0.18500752E-01 0.18499320E-01 0.83380000E+00 0.55301473E-01 0.18440550E-01 0.18431171E-01 0.18429751E-01 0.83400000E+00 0.55094019E-01 0.18371373E-01 0.18362028E-01 0.18360618E-01 0.83420000E+00 0.54887862E-01 0.18302628E-01 0.18293316E-01 0.18291918E-01 0.83440000E+00 0.54682992E-01 0.18234312E-01 0.18225034E-01 0.18223646E-01 0.83460000E+00 0.54479397E-01 0.18166422E-01 0.18157177E-01 0.18155799E-01 0.83480000E+00 0.54277067E-01 0.18098953E-01 0.18089741E-01 0.18088373E-01 0.83500000E+00 0.54075990E-01 0.18031902E-01 0.18022722E-01 0.18021365E-01 0.83520000E+00 0.53876155E-01 0.17965265E-01 0.17956118E-01 0.17954771E-01 0.83540000E+00 0.53677552E-01 0.17899039E-01 0.17889925E-01 0.17888588E-01 0.83560000E+00 0.53480170E-01 0.17833220E-01 0.17824138E-01 0.17822811E-01 0.83580000E+00 0.53283999E-01 0.17767805E-01 0.17758755E-01 0.17757438E-01 0.83600000E+00 0.53089028E-01 0.17702790E-01 0.17693773E-01 0.17692465E-01 0.83620000E+00 0.52895248E-01 0.17638172E-01 0.17629186E-01 0.17627889E-01 0.83640000E+00 0.52702647E-01 0.17573948E-01 0.17564993E-01 0.17563706E-01 0.83660000E+00 0.52511216E-01 0.17510114E-01 0.17501190E-01 0.17499912E-01 0.83680000E+00 0.52320945E-01 0.17446666E-01 0.17437774E-01 0.17436505E-01 0.83700000E+00 0.52131825E-01 0.17383602E-01 0.17374741E-01 0.17373482E-01 0.83720000E+00 0.51943845E-01 0.17320918E-01 0.17312088E-01 0.17310838E-01 0.83740000E+00 0.51756996E-01 0.17258612E-01 0.17249812E-01 0.17248571E-01 0.83760000E+00 0.51571268E-01 0.17196679E-01 0.17187910E-01 0.17186678E-01 0.83780000E+00 0.51386652E-01 0.17135118E-01 0.17126379E-01 0.17125156E-01 0.83800000E+00 0.51203140E-01 0.17073924E-01 0.17065215E-01 0.17064001E-01 0.83820000E+00 0.51020720E-01 0.17013094E-01 0.17004416E-01 0.17003211E-01 0.83840000E+00 0.50839385E-01 0.16952626E-01 0.16943978E-01 0.16942781E-01 0.83860000E+00 0.50659126E-01 0.16892517E-01 0.16883898E-01 0.16882711E-01 0.83880000E+00 0.50479933E-01 0.16832764E-01 0.16824174E-01 0.16822995E-01 0.83900000E+00 0.50301798E-01 0.16773363E-01 0.16764803E-01 0.16763633E-01 0.83920000E+00 0.50124712E-01 0.16714312E-01 0.16705781E-01 0.16704619E-01 0.83940000E+00 0.49948667E-01 0.16655608E-01 0.16647106E-01 0.16645953E-01 0.83960000E+00 0.49773653E-01 0.16597248E-01 0.16588775E-01 0.16587630E-01 0.83980000E+00 0.49599663E-01 0.16539229E-01 0.16530785E-01 0.16529648E-01 0.84000000E+00 0.49426688E-01 0.16481549E-01 0.16473133E-01 0.16472005E-01 0.84020000E+00 0.49254720E-01 0.16424205E-01 0.16415817E-01 0.16414697E-01 0.84040000E+00 0.49083750E-01 0.16367194E-01 0.16358834E-01 0.16357722E-01 0.84060000E+00 0.48913771E-01 0.16310513E-01 0.16302181E-01 0.16301077E-01 0.84080000E+00 0.48744775E-01 0.16254159E-01 0.16245856E-01 0.16244760E-01 0.84100000E+00 0.48576753E-01 0.16198131E-01 0.16189855E-01 0.16188767E-01 0.84120000E+00 0.48409698E-01 0.16142425E-01 0.16134177E-01 0.16133096E-01 0.84140000E+00 0.48243602E-01 0.16087039E-01 0.16078818E-01 0.16077745E-01 0.84160000E+00 0.48078458E-01 0.16031970E-01 0.16023777E-01 0.16022711E-01 0.84180000E+00 0.47914257E-01 0.15977215E-01 0.15969050E-01 0.15967992E-01 0.84200000E+00 0.47750993E-01 0.15922773E-01 0.15914635E-01 0.15913585E-01 0.84220000E+00 0.47588657E-01 0.15868641E-01 0.15860529E-01 0.15859487E-01 0.84240000E+00 0.47427243E-01 0.15814816E-01 0.15806731E-01 0.15805696E-01 0.84260000E+00 0.47266742E-01 0.15761296E-01 0.15753237E-01 0.15752209E-01 0.84280000E+00 0.47107149E-01 0.15708078E-01 0.15700046E-01 0.15699025E-01 0.84300000E+00 0.46948455E-01 0.15655160E-01 0.15647154E-01 0.15646141E-01 0.84320000E+00 0.46790655E-01 0.15602540E-01 0.15594560E-01 0.15593554E-01 0.84340000E+00 0.46633739E-01 0.15550215E-01 0.15542262E-01 0.15541263E-01 0.84360000E+00 0.46477703E-01 0.15498183E-01 0.15490256E-01 0.15489264E-01 0.84380000E+00 0.46322538E-01 0.15446442E-01 0.15438540E-01 0.15437555E-01 0.84400000E+00 0.46168238E-01 0.15394990E-01 0.15387113E-01 0.15386135E-01 0.84420000E+00 0.46014797E-01 0.15343823E-01 0.15335972E-01 0.15335001E-01 0.84440000E+00 0.45862207E-01 0.15292941E-01 0.15285115E-01 0.15284151E-01 0.84460000E+00 0.45710463E-01 0.15242340E-01 0.15234540E-01 0.15233582E-01 0.84480000E+00 0.45559556E-01 0.15192019E-01 0.15184244E-01 0.15183293E-01 0.84500000E+00 0.45409482E-01 0.15141975E-01 0.15134226E-01 0.15133281E-01 0.84520000E+00 0.45260234E-01 0.15092207E-01 0.15084482E-01 0.15083545E-01 0.84540000E+00 0.45111805E-01 0.15042712E-01 0.15035012E-01 0.15034081E-01 0.84560000E+00 0.44964189E-01 0.14993488E-01 0.14985813E-01 0.14984888E-01 0.84580000E+00 0.44817379E-01 0.14944533E-01 0.14936882E-01 0.14935964E-01 0.84600000E+00 0.44671371E-01 0.14895845E-01 0.14888219E-01 0.14887307E-01 0.84620000E+00 0.44526157E-01 0.14847423E-01 0.14839820E-01 0.14838914E-01 0.84640000E+00 0.44381731E-01 0.14799263E-01 0.14791684E-01 0.14790785E-01 0.84660000E+00 0.44238088E-01 0.14751363E-01 0.14743809E-01 0.14742916E-01 0.84680000E+00 0.44095222E-01 0.14703723E-01 0.14696193E-01 0.14695306E-01 0.84700000E+00 0.43953126E-01 0.14656340E-01 0.14648833E-01 0.14647953E-01 0.84720000E+00 0.43811796E-01 0.14609212E-01 0.14601729E-01 0.14600854E-01 0.84740000E+00 0.43671224E-01 0.14562338E-01 0.14554878E-01 0.14554009E-01 0.84760000E+00 0.43531407E-01 0.14515714E-01 0.14508278E-01 0.14507415E-01 0.84780000E+00 0.43392337E-01 0.14469340E-01 0.14461927E-01 0.14461070E-01 0.84800000E+00 0.43254009E-01 0.14423213E-01 0.14415823E-01 0.14414972E-01 0.84820000E+00 0.43116418E-01 0.14377332E-01 0.14369965E-01 0.14369120E-01 0.84840000E+00 0.42979558E-01 0.14331695E-01 0.14324351E-01 0.14323512E-01 0.84860000E+00 0.42843425E-01 0.14286300E-01 0.14278979E-01 0.14278145E-01 0.84880000E+00 0.42708011E-01 0.14241146E-01 0.14233847E-01 0.14233019E-01 0.84900000E+00 0.42573313E-01 0.14196229E-01 0.14188953E-01 0.14188131E-01 0.84920000E+00 0.42439325E-01 0.14151550E-01 0.14144296E-01 0.14143479E-01 0.84940000E+00 0.42306042E-01 0.14107105E-01 0.14099874E-01 0.14099063E-01 0.84960000E+00 0.42173458E-01 0.14062894E-01 0.14055685E-01 0.14054879E-01 0.84980000E+00 0.42041568E-01 0.14018914E-01 0.14011727E-01 0.14010927E-01 0.85000000E+00 0.41910368E-01 0.13975164E-01 0.13967999E-01 0.13967205E-01 0.85020000E+00 0.41779852E-01 0.13931642E-01 0.13924499E-01 0.13923710E-01 0.85040000E+00 0.41650015E-01 0.13888347E-01 0.13881226E-01 0.13880442E-01 0.85060000E+00 0.41520852E-01 0.13845277E-01 0.13838177E-01 0.13837399E-01 0.85080000E+00 0.41392359E-01 0.13802430E-01 0.13795352E-01 0.13794578E-01 0.85100000E+00 0.41264531E-01 0.13759804E-01 0.13752747E-01 0.13751979E-01 0.85120000E+00 0.41137362E-01 0.13717399E-01 0.13710363E-01 0.13709601E-01 0.85140000E+00 0.41010849E-01 0.13675212E-01 0.13668198E-01 0.13667440E-01 0.85160000E+00 0.40884986E-01 0.13633241E-01 0.13626249E-01 0.13625496E-01 0.85180000E+00 0.40759768E-01 0.13591486E-01 0.13584515E-01 0.13583767E-01 0.85200000E+00 0.40635192E-01 0.13549945E-01 0.13542994E-01 0.13542252E-01 0.85220000E+00 0.40511252E-01 0.13508616E-01 0.13501686E-01 0.13500949E-01 0.85240000E+00 0.40387944E-01 0.13467498E-01 0.13460589E-01 0.13459856E-01 0.85260000E+00 0.40265263E-01 0.13426589E-01 0.13419701E-01 0.13418973E-01 0.85280000E+00 0.40143206E-01 0.13385888E-01 0.13379020E-01 0.13378297E-01 0.85300000E+00 0.40021766E-01 0.13345393E-01 0.13338546E-01 0.13337828E-01 0.85320000E+00 0.39900942E-01 0.13305103E-01 0.13298276E-01 0.13297563E-01 0.85340000E+00 0.39780726E-01 0.13265016E-01 0.13258209E-01 0.13257501E-01 0.85360000E+00 0.39661117E-01 0.13225131E-01 0.13218345E-01 0.13217641E-01 0.85380000E+00 0.39542109E-01 0.13185447E-01 0.13178680E-01 0.13177981E-01 0.85400000E+00 0.39423697E-01 0.13145962E-01 0.13139215E-01 0.13138521E-01 0.85420000E+00 0.39305879E-01 0.13106674E-01 0.13099947E-01 0.13099258E-01 0.85440000E+00 0.39188649E-01 0.13067583E-01 0.13060876E-01 0.13060191E-01 0.85460000E+00 0.39072005E-01 0.13028687E-01 0.13021999E-01 0.13021319E-01 0.85480000E+00 0.38955940E-01 0.12989984E-01 0.12983316E-01 0.12982640E-01 0.85500000E+00 0.38840452E-01 0.12951473E-01 0.12944825E-01 0.12944154E-01 0.85520000E+00 0.38725537E-01 0.12913154E-01 0.12906525E-01 0.12905858E-01 0.85540000E+00 0.38611190E-01 0.12875024E-01 0.12868414E-01 0.12867752E-01 0.85560000E+00 0.38497408E-01 0.12837082E-01 0.12830492E-01 0.12829834E-01 0.85580000E+00 0.38384186E-01 0.12799328E-01 0.12792756E-01 0.12792102E-01 0.85600000E+00 0.38271522E-01 0.12761759E-01 0.12755206E-01 0.12754557E-01 0.85620000E+00 0.38159410E-01 0.12724374E-01 0.12717841E-01 0.12717195E-01 0.85640000E+00 0.38047848E-01 0.12687173E-01 0.12680658E-01 0.12680017E-01 0.85660000E+00 0.37936831E-01 0.12650153E-01 0.12643657E-01 0.12643020E-01 0.85680000E+00 0.37826356E-01 0.12613314E-01 0.12606837E-01 0.12606204E-01 0.85700000E+00 0.37716419E-01 0.12576655E-01 0.12570196E-01 0.12569568E-01 0.85720000E+00 0.37607016E-01 0.12540173E-01 0.12533734E-01 0.12533109E-01 0.85740000E+00 0.37498145E-01 0.12503869E-01 0.12497448E-01 0.12496827E-01 0.85760000E+00 0.37389800E-01 0.12467741E-01 0.12461338E-01 0.12460721E-01 0.85780000E+00 0.37281979E-01 0.12431787E-01 0.12425402E-01 0.12424790E-01 0.85800000E+00 0.37174678E-01 0.12396007E-01 0.12389640E-01 0.12389032E-01 0.85820000E+00 0.37067894E-01 0.12360398E-01 0.12354050E-01 0.12353446E-01 0.85840000E+00 0.36961623E-01 0.12324961E-01 0.12318631E-01 0.12318030E-01 0.85860000E+00 0.36855861E-01 0.12289694E-01 0.12283382E-01 0.12282785E-01 0.85880000E+00 0.36750606E-01 0.12254596E-01 0.12248301E-01 0.12247709E-01 0.85900000E+00 0.36645854E-01 0.12219665E-01 0.12213388E-01 0.12212800E-01 0.85920000E+00 0.36541601E-01 0.12184901E-01 0.12178642E-01 0.12178057E-01 0.85940000E+00 0.36437844E-01 0.12150303E-01 0.12144061E-01 0.12143480E-01 0.85960000E+00 0.36334580E-01 0.12115869E-01 0.12109644E-01 0.12109067E-01 0.85980000E+00 0.36231806E-01 0.12081598E-01 0.12075391E-01 0.12074817E-01 0.86000000E+00 0.36129518E-01 0.12047489E-01 0.12041300E-01 0.12040730E-01 0.86020000E+00 0.36027714E-01 0.12013541E-01 0.12007369E-01 0.12006803E-01 0.86040000E+00 0.35926389E-01 0.11979754E-01 0.11973599E-01 0.11973036E-01 0.86060000E+00 0.35825541E-01 0.11946125E-01 0.11939987E-01 0.11939429E-01 0.86080000E+00 0.35725167E-01 0.11912655E-01 0.11906534E-01 0.11905979E-01 0.86100000E+00 0.35625263E-01 0.11879341E-01 0.11873237E-01 0.11872685E-01 0.86120000E+00 0.35525827E-01 0.11846183E-01 0.11840096E-01 0.11839548E-01 0.86140000E+00 0.35426855E-01 0.11813180E-01 0.11807110E-01 0.11806565E-01 0.86160000E+00 0.35328345E-01 0.11780331E-01 0.11774278E-01 0.11773737E-01 0.86180000E+00 0.35230293E-01 0.11747635E-01 0.11741598E-01 0.11741060E-01 0.86200000E+00 0.35132697E-01 0.11715090E-01 0.11709070E-01 0.11708536E-01 0.86220000E+00 0.35035552E-01 0.11682697E-01 0.11676693E-01 0.11676163E-01 0.86240000E+00 0.34938858E-01 0.11650453E-01 0.11644466E-01 0.11643939E-01 0.86260000E+00 0.34842610E-01 0.11618358E-01 0.11612388E-01 0.11611864E-01 0.86280000E+00 0.34746806E-01 0.11586412E-01 0.11580457E-01 0.11579937E-01 0.86300000E+00 0.34651443E-01 0.11554612E-01 0.11548674E-01 0.11548157E-01 0.86320000E+00 0.34556517E-01 0.11522958E-01 0.11517036E-01 0.11516523E-01 0.86340000E+00 0.34462027E-01 0.11491450E-01 0.11485544E-01 0.11485033E-01 0.86360000E+00 0.34367970E-01 0.11460086E-01 0.11454196E-01 0.11453688E-01 0.86380000E+00 0.34274342E-01 0.11428865E-01 0.11422991E-01 0.11422487E-01 0.86400000E+00 0.34181141E-01 0.11397786E-01 0.11391928E-01 0.11391427E-01 0.86420000E+00 0.34088364E-01 0.11366849E-01 0.11361006E-01 0.11360509E-01 0.86440000E+00 0.33996009E-01 0.11336052E-01 0.11330226E-01 0.11329731E-01 0.86460000E+00 0.33904073E-01 0.11305395E-01 0.11299584E-01 0.11299093E-01 0.86480000E+00 0.33812552E-01 0.11274877E-01 0.11269082E-01 0.11268594E-01 0.86500000E+00 0.33721446E-01 0.11244497E-01 0.11238717E-01 0.11238232E-01 0.86520000E+00 0.33630750E-01 0.11214254E-01 0.11208489E-01 0.11208007E-01 0.86540000E+00 0.33540463E-01 0.11184147E-01 0.11178398E-01 0.11177919E-01 0.86560000E+00 0.33450581E-01 0.11154175E-01 0.11148441E-01 0.11147965E-01 0.86580000E+00 0.33361103E-01 0.11124337E-01 0.11118619E-01 0.11118146E-01 0.86600000E+00 0.33272025E-01 0.11094634E-01 0.11088931E-01 0.11088461E-01 0.86620000E+00 0.33183346E-01 0.11065063E-01 0.11059375E-01 0.11058908E-01 0.86640000E+00 0.33095062E-01 0.11035624E-01 0.11029951E-01 0.11029487E-01 0.86660000E+00 0.33007172E-01 0.11006316E-01 0.11000658E-01 0.11000198E-01 0.86680000E+00 0.32919672E-01 0.10977139E-01 0.10971496E-01 0.10971038E-01 0.86700000E+00 0.32832561E-01 0.10948091E-01 0.10942463E-01 0.10942008E-01 0.86720000E+00 0.32745836E-01 0.10919172E-01 0.10913558E-01 0.10913106E-01 0.86740000E+00 0.32659494E-01 0.10890380E-01 0.10884782E-01 0.10884332E-01 0.86760000E+00 0.32573534E-01 0.10861716E-01 0.10856132E-01 0.10855686E-01 0.86780000E+00 0.32487952E-01 0.10833178E-01 0.10827609E-01 0.10827165E-01 0.86800000E+00 0.32402747E-01 0.10804766E-01 0.10799211E-01 0.10798770E-01 0.86820000E+00 0.32317916E-01 0.10776478E-01 0.10770938E-01 0.10770500E-01 0.86840000E+00 0.32233457E-01 0.10748315E-01 0.10742789E-01 0.10742354E-01 0.86860000E+00 0.32149368E-01 0.10720274E-01 0.10714763E-01 0.10714331E-01 0.86880000E+00 0.32065646E-01 0.10692357E-01 0.10686859E-01 0.10686430E-01 0.86900000E+00 0.31982289E-01 0.10664561E-01 0.10659078E-01 0.10658651E-01 0.86920000E+00 0.31899295E-01 0.10636886E-01 0.10631417E-01 0.10630993E-01 0.86940000E+00 0.31816662E-01 0.10609331E-01 0.10603876E-01 0.10603455E-01 0.86960000E+00 0.31734387E-01 0.10581896E-01 0.10576455E-01 0.10576036E-01 0.86980000E+00 0.31652469E-01 0.10554579E-01 0.10549153E-01 0.10548737E-01 0.87000000E+00 0.31570904E-01 0.10527381E-01 0.10521968E-01 0.10521555E-01 0.87020000E+00 0.31489692E-01 0.10500300E-01 0.10494901E-01 0.10494490E-01 0.87040000E+00 0.31408830E-01 0.10473336E-01 0.10467951E-01 0.10467543E-01 0.87060000E+00 0.31328315E-01 0.10446488E-01 0.10441117E-01 0.10440711E-01 0.87080000E+00 0.31248146E-01 0.10419755E-01 0.10414397E-01 0.10413994E-01 0.87100000E+00 0.31168321E-01 0.10393136E-01 0.10387793E-01 0.10387392E-01 0.87120000E+00 0.31088838E-01 0.10366632E-01 0.10361302E-01 0.10360904E-01 0.87140000E+00 0.31009694E-01 0.10340241E-01 0.10334924E-01 0.10334529E-01 0.87160000E+00 0.30930887E-01 0.10313962E-01 0.10308659E-01 0.10308266E-01 0.87180000E+00 0.30852416E-01 0.10287795E-01 0.10282506E-01 0.10282115E-01 0.87200000E+00 0.30774279E-01 0.10261740E-01 0.10256464E-01 0.10256075E-01 0.87220000E+00 0.30696472E-01 0.10235795E-01 0.10230532E-01 0.10230146E-01 0.87240000E+00 0.30618996E-01 0.10209960E-01 0.10204710E-01 0.10204327E-01 0.87260000E+00 0.30541847E-01 0.10184234E-01 0.10178997E-01 0.10178616E-01 0.87280000E+00 0.30465024E-01 0.10158616E-01 0.10153393E-01 0.10153015E-01 0.87300000E+00 0.30388524E-01 0.10133107E-01 0.10127897E-01 0.10127521E-01 0.87320000E+00 0.30312347E-01 0.10107705E-01 0.10102508E-01 0.10102134E-01 0.87340000E+00 0.30236489E-01 0.10082410E-01 0.10077226E-01 0.10076854E-01 0.87360000E+00 0.30160950E-01 0.10057220E-01 0.10052049E-01 0.10051680E-01 0.87380000E+00 0.30085726E-01 0.10032136E-01 0.10026978E-01 0.10026611E-01 0.87400000E+00 0.30010817E-01 0.10007157E-01 0.10002012E-01 0.10001648E-01 0.87420000E+00 0.29936221E-01 0.99822826E-02 0.99771502E-02 0.99767878E-02 0.87440000E+00 0.29861935E-01 0.99575114E-02 0.99523917E-02 0.99520317E-02 0.87460000E+00 0.29787958E-01 0.99328433E-02 0.99277362E-02 0.99273784E-02 0.87480000E+00 0.29714288E-01 0.99082775E-02 0.99031831E-02 0.99028275E-02 0.87500000E+00 0.29640923E-01 0.98838135E-02 0.98787317E-02 0.98783783E-02 0.87520000E+00 0.29567862E-01 0.98594507E-02 0.98543814E-02 0.98540303E-02 0.87540000E+00 0.29495103E-01 0.98351886E-02 0.98301318E-02 0.98297829E-02 0.87560000E+00 0.29422644E-01 0.98110265E-02 0.98059822E-02 0.98056354E-02 0.87580000E+00 0.29350483E-01 0.97869639E-02 0.97819320E-02 0.97815874E-02 0.87600000E+00 0.29278619E-01 0.97630002E-02 0.97579806E-02 0.97576382E-02 0.87620000E+00 0.29207050E-01 0.97391349E-02 0.97341275E-02 0.97337873E-02 0.87640000E+00 0.29135774E-01 0.97153673E-02 0.97103722E-02 0.97100340E-02 0.87660000E+00 0.29064789E-01 0.96916969E-02 0.96867140E-02 0.96863780E-02 0.87680000E+00 0.28994094E-01 0.96681232E-02 0.96631524E-02 0.96628185E-02 0.87700000E+00 0.28923688E-01 0.96446456E-02 0.96396869E-02 0.96393551E-02 0.87720000E+00 0.28853568E-01 0.96212635E-02 0.96163169E-02 0.96159871E-02 0.87740000E+00 0.28783732E-01 0.95979765E-02 0.95930418E-02 0.95927141E-02 0.87760000E+00 0.28714181E-01 0.95747839E-02 0.95698612E-02 0.95695356E-02 0.87780000E+00 0.28644911E-01 0.95516852E-02 0.95467745E-02 0.95464509E-02 0.87800000E+00 0.28575921E-01 0.95286800E-02 0.95237811E-02 0.95234595E-02 0.87820000E+00 0.28507209E-01 0.95057677E-02 0.95008806E-02 0.95005610E-02 0.87840000E+00 0.28438775E-01 0.94829477E-02 0.94780723E-02 0.94777547E-02 0.87860000E+00 0.28370616E-01 0.94602195E-02 0.94553559E-02 0.94550403E-02 0.87880000E+00 0.28302730E-01 0.94375826E-02 0.94327307E-02 0.94324171E-02 0.87900000E+00 0.28235118E-01 0.94150366E-02 0.94101963E-02 0.94098846E-02 0.87920000E+00 0.28167775E-01 0.93925809E-02 0.93877521E-02 0.93874424E-02 0.87940000E+00 0.28100702E-01 0.93702149E-02 0.93653977E-02 0.93650899E-02 0.87960000E+00 0.28033897E-01 0.93479382E-02 0.93431325E-02 0.93428266E-02 0.87980000E+00 0.27967359E-01 0.93257503E-02 0.93209561E-02 0.93206521E-02 0.88000000E+00 0.27901084E-01 0.93036507E-02 0.92988679E-02 0.92985658E-02 0.88020000E+00 0.27835074E-01 0.92816389E-02 0.92768675E-02 0.92765673E-02 0.88040000E+00 0.27769325E-01 0.92597145E-02 0.92549543E-02 0.92546560E-02 0.88060000E+00 0.27703836E-01 0.92378768E-02 0.92331279E-02 0.92328315E-02 0.88080000E+00 0.27638607E-01 0.92161255E-02 0.92113879E-02 0.92110932E-02 0.88100000E+00 0.27573635E-01 0.91944601E-02 0.91897336E-02 0.91894409E-02 0.88120000E+00 0.27508919E-01 0.91728801E-02 0.91681648E-02 0.91678738E-02 0.88140000E+00 0.27444457E-01 0.91513850E-02 0.91466808E-02 0.91463916E-02 0.88160000E+00 0.27380249E-01 0.91299744E-02 0.91252812E-02 0.91249939E-02 0.88180000E+00 0.27316293E-01 0.91086477E-02 0.91039656E-02 0.91036800E-02 0.88200000E+00 0.27252588E-01 0.90874047E-02 0.90827335E-02 0.90824497E-02 0.88220000E+00 0.27189131E-01 0.90662446E-02 0.90615844E-02 0.90613024E-02 0.88240000E+00 0.27125923E-01 0.90451672E-02 0.90405179E-02 0.90402376E-02 0.88260000E+00 0.27062961E-01 0.90241720E-02 0.90195335E-02 0.90192550E-02 0.88280000E+00 0.27000243E-01 0.90032585E-02 0.89986308E-02 0.89983541E-02 0.88300000E+00 0.26937770E-01 0.89824263E-02 0.89778094E-02 0.89775343E-02 0.88320000E+00 0.26875539E-01 0.89616750E-02 0.89570687E-02 0.89567954E-02 0.88340000E+00 0.26813549E-01 0.89410040E-02 0.89364084E-02 0.89361368E-02 0.88360000E+00 0.26751799E-01 0.89204130E-02 0.89158281E-02 0.89155582E-02 0.88380000E+00 0.26690288E-01 0.88999015E-02 0.88953272E-02 0.88950590E-02 0.88400000E+00 0.26629013E-01 0.88794692E-02 0.88749054E-02 0.88746389E-02 0.88420000E+00 0.26567975E-01 0.88591155E-02 0.88545622E-02 0.88542974E-02 0.88440000E+00 0.26507171E-01 0.88388400E-02 0.88342973E-02 0.88340341E-02 0.88460000E+00 0.26446601E-01 0.88186425E-02 0.88141101E-02 0.88138485E-02 0.88480000E+00 0.26386263E-01 0.87985223E-02 0.87940003E-02 0.87937404E-02 0.88500000E+00 0.26326156E-01 0.87784791E-02 0.87739675E-02 0.87737092E-02 0.88520000E+00 0.26266278E-01 0.87585125E-02 0.87540113E-02 0.87537546E-02 0.88540000E+00 0.26206629E-01 0.87386221E-02 0.87341311E-02 0.87338760E-02 0.88560000E+00 0.26147207E-01 0.87188074E-02 0.87143267E-02 0.87140732E-02 0.88580000E+00 0.26088012E-01 0.86990682E-02 0.86945977E-02 0.86943458E-02 0.88600000E+00 0.26029041E-01 0.86794039E-02 0.86749435E-02 0.86746932E-02 0.88620000E+00 0.25970293E-01 0.86598141E-02 0.86553639E-02 0.86551152E-02 0.88640000E+00 0.25911768E-01 0.86402986E-02 0.86358585E-02 0.86356113E-02 0.88660000E+00 0.25853465E-01 0.86208568E-02 0.86164268E-02 0.86161811E-02 0.88680000E+00 0.25795381E-01 0.86014884E-02 0.85970684E-02 0.85968243E-02 0.88700000E+00 0.25737516E-01 0.85821930E-02 0.85777830E-02 0.85775404E-02 0.88720000E+00 0.25679870E-01 0.85629703E-02 0.85585702E-02 0.85583291E-02 0.88740000E+00 0.25622439E-01 0.85438198E-02 0.85394296E-02 0.85391900E-02 0.88760000E+00 0.25565225E-01 0.85247411E-02 0.85203608E-02 0.85201228E-02 0.88780000E+00 0.25508224E-01 0.85057339E-02 0.85013635E-02 0.85011269E-02 0.88800000E+00 0.25451437E-01 0.84867979E-02 0.84824372E-02 0.84822021E-02 0.88820000E+00 0.25394862E-01 0.84679325E-02 0.84635817E-02 0.84633480E-02 0.88840000E+00 0.25338498E-01 0.84491376E-02 0.84447964E-02 0.84445643E-02 0.88860000E+00 0.25282344E-01 0.84304126E-02 0.84260812E-02 0.84258505E-02 0.88880000E+00 0.25226399E-01 0.84117573E-02 0.84074355E-02 0.84072062E-02 0.88900000E+00 0.25170662E-01 0.83931712E-02 0.83888591E-02 0.83886312E-02 0.88920000E+00 0.25115131E-01 0.83746541E-02 0.83703515E-02 0.83701251E-02 0.88940000E+00 0.25059805E-01 0.83562055E-02 0.83519125E-02 0.83516875E-02 0.88960000E+00 0.25004685E-01 0.83378251E-02 0.83335416E-02 0.83333181E-02 0.88980000E+00 0.24949768E-01 0.83195126E-02 0.83152385E-02 0.83150164E-02 0.89000000E+00 0.24895053E-01 0.83012675E-02 0.82970030E-02 0.82967822E-02 0.89020000E+00 0.24840539E-01 0.82830896E-02 0.82788345E-02 0.82786151E-02 0.89040000E+00 0.24786226E-01 0.82649786E-02 0.82607328E-02 0.82605148E-02 0.89060000E+00 0.24732112E-01 0.82469339E-02 0.82426975E-02 0.82424809E-02 0.89080000E+00 0.24678197E-01 0.82289554E-02 0.82247283E-02 0.82245131E-02 0.89100000E+00 0.24624479E-01 0.82110427E-02 0.82068249E-02 0.82066110E-02 0.89120000E+00 0.24570957E-01 0.81931954E-02 0.81889868E-02 0.81887743E-02 0.89140000E+00 0.24517630E-01 0.81754133E-02 0.81712139E-02 0.81710027E-02 0.89160000E+00 0.24464497E-01 0.81576959E-02 0.81535057E-02 0.81532958E-02 0.89180000E+00 0.24411558E-01 0.81400429E-02 0.81358619E-02 0.81356534E-02 0.89200000E+00 0.24358811E-01 0.81224541E-02 0.81182822E-02 0.81180750E-02 0.89220000E+00 0.24306256E-01 0.81049291E-02 0.81007663E-02 0.81005604E-02 0.89240000E+00 0.24253891E-01 0.80874676E-02 0.80833138E-02 0.80831092E-02 0.89260000E+00 0.24201715E-01 0.80700692E-02 0.80659244E-02 0.80657211E-02 0.89280000E+00 0.24149727E-01 0.80527336E-02 0.80485978E-02 0.80483958E-02 0.89300000E+00 0.24097927E-01 0.80354605E-02 0.80313337E-02 0.80311330E-02 0.89320000E+00 0.24046314E-01 0.80182497E-02 0.80141318E-02 0.80139323E-02 0.89340000E+00 0.23994886E-01 0.80011007E-02 0.79969917E-02 0.79967935E-02 0.89360000E+00 0.23943643E-01 0.79840133E-02 0.79799132E-02 0.79797162E-02 0.89380000E+00 0.23892583E-01 0.79669872E-02 0.79628959E-02 0.79627002E-02 0.89400000E+00 0.23841707E-01 0.79500220E-02 0.79459395E-02 0.79457451E-02 0.89420000E+00 0.23791012E-01 0.79331175E-02 0.79290438E-02 0.79288506E-02 0.89440000E+00 0.23740498E-01 0.79162734E-02 0.79122083E-02 0.79120164E-02 0.89460000E+00 0.23690164E-01 0.78994892E-02 0.78954329E-02 0.78952422E-02 0.89480000E+00 0.23640010E-01 0.78827649E-02 0.78787172E-02 0.78785277E-02 0.89500000E+00 0.23590034E-01 0.78661000E-02 0.78620610E-02 0.78618726E-02 0.89520000E+00 0.23540235E-01 0.78494942E-02 0.78454638E-02 0.78452767E-02 0.89540000E+00 0.23490612E-01 0.78329473E-02 0.78289255E-02 0.78287396E-02 0.89560000E+00 0.23441166E-01 0.78164590E-02 0.78124457E-02 0.78122610E-02 0.89580000E+00 0.23391894E-01 0.78000289E-02 0.77960242E-02 0.77958406E-02 0.89600000E+00 0.23342796E-01 0.77836569E-02 0.77796607E-02 0.77794783E-02 0.89620000E+00 0.23293871E-01 0.77673425E-02 0.77633548E-02 0.77631736E-02 0.89640000E+00 0.23245118E-01 0.77510856E-02 0.77471063E-02 0.77469262E-02 0.89660000E+00 0.23196537E-01 0.77348858E-02 0.77309149E-02 0.77307360E-02 0.89680000E+00 0.23148126E-01 0.77187429E-02 0.77147804E-02 0.77146026E-02 0.89700000E+00 0.23099885E-01 0.77026566E-02 0.76987024E-02 0.76985258E-02 0.89720000E+00 0.23051812E-01 0.76866265E-02 0.76826807E-02 0.76825052E-02 0.89740000E+00 0.23003908E-01 0.76706525E-02 0.76667150E-02 0.76665406E-02 0.89760000E+00 0.22956171E-01 0.76547343E-02 0.76508050E-02 0.76506317E-02 0.89780000E+00 0.22908600E-01 0.76388715E-02 0.76349504E-02 0.76347783E-02 0.89800000E+00 0.22861195E-01 0.76230639E-02 0.76191511E-02 0.76189800E-02 0.89820000E+00 0.22813955E-01 0.76073113E-02 0.76034066E-02 0.76032367E-02 0.89840000E+00 0.22766878E-01 0.75916134E-02 0.75877168E-02 0.75875480E-02 0.89860000E+00 0.22719965E-01 0.75759698E-02 0.75720814E-02 0.75719136E-02 0.89880000E+00 0.22673214E-01 0.75603804E-02 0.75565001E-02 0.75563334E-02 0.89900000E+00 0.22626625E-01 0.75448449E-02 0.75409727E-02 0.75408071E-02 0.89920000E+00 0.22580196E-01 0.75293630E-02 0.75254988E-02 0.75253343E-02 0.89940000E+00 0.22533928E-01 0.75139345E-02 0.75100783E-02 0.75099148E-02 0.89960000E+00 0.22487818E-01 0.74985591E-02 0.74947109E-02 0.74945485E-02 0.89980000E+00 0.22441868E-01 0.74832366E-02 0.74793963E-02 0.74792349E-02 0.90000000E+00 0.22396075E-01 0.74679666E-02 0.74641342E-02 0.74639739E-02 0.90020000E+00 0.22350439E-01 0.74527490E-02 0.74489245E-02 0.74487653E-02 0.90040000E+00 0.22304959E-01 0.74375835E-02 0.74337669E-02 0.74336087E-02 0.90060000E+00 0.22259635E-01 0.74224698E-02 0.74186611E-02 0.74185039E-02 0.90080000E+00 0.22214465E-01 0.74074077E-02 0.74036068E-02 0.74034506E-02 0.90100000E+00 0.22169450E-01 0.73923970E-02 0.73886039E-02 0.73884487E-02 0.90120000E+00 0.22124587E-01 0.73774374E-02 0.73736520E-02 0.73734979E-02 0.90140000E+00 0.22079877E-01 0.73625286E-02 0.73587510E-02 0.73585979E-02 0.90160000E+00 0.22035320E-01 0.73476705E-02 0.73439006E-02 0.73437485E-02 0.90180000E+00 0.21990913E-01 0.73328627E-02 0.73291005E-02 0.73289494E-02 0.90200000E+00 0.21946656E-01 0.73181051E-02 0.73143506E-02 0.73142004E-02 0.90220000E+00 0.21902549E-01 0.73033974E-02 0.72996505E-02 0.72995014E-02 0.90240000E+00 0.21858591E-01 0.72887393E-02 0.72850001E-02 0.72848519E-02 0.90260000E+00 0.21814782E-01 0.72741307E-02 0.72703991E-02 0.72702519E-02 0.90280000E+00 0.21771120E-01 0.72595713E-02 0.72558472E-02 0.72557010E-02 0.90300000E+00 0.21727604E-01 0.72450609E-02 0.72413443E-02 0.72411991E-02 0.90320000E+00 0.21684235E-01 0.72305992E-02 0.72268902E-02 0.72267458E-02 0.90340000E+00 0.21641012E-01 0.72161860E-02 0.72124845E-02 0.72123411E-02 0.90360000E+00 0.21597933E-01 0.72018211E-02 0.71981270E-02 0.71979846E-02 0.90380000E+00 0.21554998E-01 0.71875043E-02 0.71838176E-02 0.71836761E-02 0.90400000E+00 0.21512207E-01 0.71732352E-02 0.71695560E-02 0.71694155E-02 0.90420000E+00 0.21469558E-01 0.71590138E-02 0.71553420E-02 0.71552024E-02 0.90440000E+00 0.21427052E-01 0.71448398E-02 0.71411754E-02 0.71410367E-02 0.90460000E+00 0.21384687E-01 0.71307130E-02 0.71270558E-02 0.71269181E-02 0.90480000E+00 0.21342463E-01 0.71166330E-02 0.71129832E-02 0.71128464E-02 0.90500000E+00 0.21300379E-01 0.71025999E-02 0.70989574E-02 0.70988214E-02 0.90520000E+00 0.21258434E-01 0.70886132E-02 0.70849780E-02 0.70848429E-02 0.90540000E+00 0.21216628E-01 0.70746728E-02 0.70710448E-02 0.70709107E-02 0.90560000E+00 0.21174961E-01 0.70607785E-02 0.70571577E-02 0.70570245E-02 0.90580000E+00 0.21133431E-01 0.70469301E-02 0.70433165E-02 0.70431842E-02 0.90600000E+00 0.21092038E-01 0.70331273E-02 0.70295209E-02 0.70293895E-02 0.90620000E+00 0.21050781E-01 0.70193700E-02 0.70157707E-02 0.70156402E-02 0.90640000E+00 0.21009660E-01 0.70056579E-02 0.70020658E-02 0.70019361E-02 0.90660000E+00 0.20968674E-01 0.69919908E-02 0.69884058E-02 0.69882770E-02 0.90680000E+00 0.20927822E-01 0.69783686E-02 0.69747907E-02 0.69746627E-02 0.90700000E+00 0.20887104E-01 0.69647910E-02 0.69612201E-02 0.69610930E-02 0.90720000E+00 0.20846519E-01 0.69512578E-02 0.69476939E-02 0.69475677E-02 0.90740000E+00 0.20806067E-01 0.69377687E-02 0.69342119E-02 0.69340865E-02 0.90760000E+00 0.20765747E-01 0.69243238E-02 0.69207739E-02 0.69206494E-02 0.90780000E+00 0.20725558E-01 0.69109226E-02 0.69073797E-02 0.69072560E-02 0.90800000E+00 0.20685500E-01 0.68975650E-02 0.68940291E-02 0.68939062E-02 0.90820000E+00 0.20645572E-01 0.68842508E-02 0.68807218E-02 0.68805998E-02 0.90840000E+00 0.20605774E-01 0.68709798E-02 0.68674578E-02 0.68673366E-02 0.90860000E+00 0.20566105E-01 0.68577519E-02 0.68542367E-02 0.68541163E-02 0.90880000E+00 0.20526564E-01 0.68445668E-02 0.68410584E-02 0.68409389E-02 0.90900000E+00 0.20487151E-01 0.68314242E-02 0.68279227E-02 0.68278040E-02 0.90920000E+00 0.20447865E-01 0.68183242E-02 0.68148295E-02 0.68147116E-02 0.90940000E+00 0.20408706E-01 0.68052663E-02 0.68017784E-02 0.68016613E-02 0.90960000E+00 0.20369673E-01 0.67922506E-02 0.67887694E-02 0.67886531E-02 0.90980000E+00 0.20330766E-01 0.67792766E-02 0.67758023E-02 0.67756867E-02 0.91000000E+00 0.20291983E-01 0.67663444E-02 0.67628767E-02 0.67627620E-02 0.91020000E+00 0.20253325E-01 0.67534536E-02 0.67499927E-02 0.67498788E-02 0.91040000E+00 0.20214791E-01 0.67406042E-02 0.67371499E-02 0.67370368E-02 0.91060000E+00 0.20176380E-01 0.67277958E-02 0.67243482E-02 0.67242359E-02 0.91080000E+00 0.20138092E-01 0.67150284E-02 0.67115875E-02 0.67114759E-02 0.91100000E+00 0.20099926E-01 0.67023018E-02 0.66988674E-02 0.66987566E-02 0.91120000E+00 0.20061881E-01 0.66896157E-02 0.66861879E-02 0.66860779E-02 0.91140000E+00 0.20023958E-01 0.66769700E-02 0.66735488E-02 0.66734395E-02 0.91160000E+00 0.19986156E-01 0.66643645E-02 0.66609498E-02 0.66608413E-02 0.91180000E+00 0.19948473E-01 0.66517990E-02 0.66483909E-02 0.66482831E-02 0.91200000E+00 0.19910910E-01 0.66392733E-02 0.66358718E-02 0.66357648E-02 0.91220000E+00 0.19873466E-01 0.66267874E-02 0.66233923E-02 0.66232861E-02 0.91240000E+00 0.19836140E-01 0.66143409E-02 0.66109524E-02 0.66108468E-02 0.91260000E+00 0.19798932E-01 0.66019338E-02 0.65985517E-02 0.65984469E-02 0.91280000E+00 0.19761842E-01 0.65895658E-02 0.65861901E-02 0.65860861E-02 0.91300000E+00 0.19724869E-01 0.65772368E-02 0.65738675E-02 0.65737642E-02 0.91320000E+00 0.19688011E-01 0.65649466E-02 0.65615837E-02 0.65614811E-02 0.91340000E+00 0.19651270E-01 0.65526950E-02 0.65493385E-02 0.65492367E-02 0.91360000E+00 0.19614644E-01 0.65404819E-02 0.65371317E-02 0.65370306E-02 0.91380000E+00 0.19578133E-01 0.65283071E-02 0.65249633E-02 0.65248629E-02 0.91400000E+00 0.19541736E-01 0.65161704E-02 0.65128329E-02 0.65127332E-02 0.91420000E+00 0.19505454E-01 0.65040717E-02 0.65007405E-02 0.65006415E-02 0.91440000E+00 0.19469284E-01 0.64920107E-02 0.64886858E-02 0.64885875E-02 0.91460000E+00 0.19433227E-01 0.64799874E-02 0.64766687E-02 0.64765712E-02 0.91480000E+00 0.19397283E-01 0.64680016E-02 0.64646891E-02 0.64645923E-02 0.91500000E+00 0.19361450E-01 0.64560530E-02 0.64527468E-02 0.64526506E-02 0.91520000E+00 0.19325729E-01 0.64441416E-02 0.64408416E-02 0.64407461E-02 0.91540000E+00 0.19290119E-01 0.64322672E-02 0.64289734E-02 0.64288786E-02 0.91560000E+00 0.19254619E-01 0.64204296E-02 0.64171419E-02 0.64170478E-02 0.91580000E+00 0.19219229E-01 0.64086286E-02 0.64053471E-02 0.64052537E-02 0.91600000E+00 0.19183949E-01 0.63968642E-02 0.63935888E-02 0.63934960E-02 0.91620000E+00 0.19148777E-01 0.63851361E-02 0.63818668E-02 0.63817747E-02 0.91640000E+00 0.19113715E-01 0.63734441E-02 0.63701809E-02 0.63700895E-02 0.91660000E+00 0.19078760E-01 0.63617882E-02 0.63585311E-02 0.63584403E-02 0.91680000E+00 0.19043912E-01 0.63501682E-02 0.63469171E-02 0.63468270E-02 0.91700000E+00 0.19009172E-01 0.63385839E-02 0.63353388E-02 0.63352494E-02 0.91720000E+00 0.18974539E-01 0.63270351E-02 0.63237961E-02 0.63237073E-02 0.91740000E+00 0.18940011E-01 0.63155218E-02 0.63122887E-02 0.63122006E-02 0.91760000E+00 0.18905590E-01 0.63040437E-02 0.63008166E-02 0.63007292E-02 0.91780000E+00 0.18871273E-01 0.62926008E-02 0.62893796E-02 0.62892928E-02 0.91800000E+00 0.18837062E-01 0.62811927E-02 0.62779776E-02 0.62778914E-02 0.91820000E+00 0.18802955E-01 0.62698195E-02 0.62666103E-02 0.62665247E-02 0.91840000E+00 0.18768951E-01 0.62584810E-02 0.62552776E-02 0.62551928E-02 0.91860000E+00 0.18735052E-01 0.62471770E-02 0.62439795E-02 0.62438952E-02 0.91880000E+00 0.18701255E-01 0.62359073E-02 0.62327157E-02 0.62326321E-02 0.91900000E+00 0.18667561E-01 0.62246719E-02 0.62214861E-02 0.62214031E-02 0.91920000E+00 0.18633969E-01 0.62134705E-02 0.62102906E-02 0.62102082E-02 0.91940000E+00 0.18600479E-01 0.62023031E-02 0.61991290E-02 0.61990472E-02 0.91960000E+00 0.18567091E-01 0.61911694E-02 0.61880011E-02 0.61879200E-02 0.91980000E+00 0.18533803E-01 0.61800694E-02 0.61769069E-02 0.61768264E-02 0.92000000E+00 0.18500615E-01 0.61690029E-02 0.61658462E-02 0.61657662E-02 0.92020000E+00 0.18467528E-01 0.61579698E-02 0.61548188E-02 0.61547395E-02 0.92040000E+00 0.18434540E-01 0.61469699E-02 0.61438246E-02 0.61437459E-02 0.92060000E+00 0.18401652E-01 0.61360030E-02 0.61328634E-02 0.61327853E-02 0.92080000E+00 0.18368862E-01 0.61250691E-02 0.61219352E-02 0.61218577E-02 0.92100000E+00 0.18336171E-01 0.61141680E-02 0.61110398E-02 0.61109629E-02 0.92120000E+00 0.18303577E-01 0.61032996E-02 0.61001770E-02 0.61001007E-02 0.92140000E+00 0.18271082E-01 0.60924637E-02 0.60893468E-02 0.60892710E-02 0.92160000E+00 0.18238683E-01 0.60816602E-02 0.60785489E-02 0.60784737E-02 0.92180000E+00 0.18206381E-01 0.60708889E-02 0.60677832E-02 0.60677087E-02 0.92200000E+00 0.18174175E-01 0.60601498E-02 0.60570497E-02 0.60569757E-02 0.92220000E+00 0.18142065E-01 0.60494427E-02 0.60463481E-02 0.60462747E-02 0.92240000E+00 0.18110051E-01 0.60387674E-02 0.60356784E-02 0.60356056E-02 0.92260000E+00 0.18078132E-01 0.60281238E-02 0.60250404E-02 0.60249681E-02 0.92280000E+00 0.18046308E-01 0.60175118E-02 0.60144339E-02 0.60143622E-02 0.92300000E+00 0.18014578E-01 0.60069313E-02 0.60038589E-02 0.60037878E-02 0.92320000E+00 0.17982942E-01 0.59963821E-02 0.59933152E-02 0.59932446E-02 0.92340000E+00 0.17951399E-01 0.59858641E-02 0.59828027E-02 0.59827327E-02 0.92360000E+00 0.17919950E-01 0.59753772E-02 0.59723212E-02 0.59722517E-02 0.92380000E+00 0.17888594E-01 0.59649212E-02 0.59618707E-02 0.59618018E-02 0.92400000E+00 0.17857330E-01 0.59544960E-02 0.59514509E-02 0.59513826E-02 0.92420000E+00 0.17826157E-01 0.59441015E-02 0.59410618E-02 0.59409940E-02 0.92440000E+00 0.17795077E-01 0.59337376E-02 0.59307033E-02 0.59306361E-02 0.92460000E+00 0.17764088E-01 0.59234041E-02 0.59203752E-02 0.59203085E-02 0.92480000E+00 0.17733190E-01 0.59131009E-02 0.59100774E-02 0.59100112E-02 0.92500000E+00 0.17702382E-01 0.59028279E-02 0.58998098E-02 0.58997441E-02 0.92520000E+00 0.17671664E-01 0.58925850E-02 0.58895722E-02 0.58895071E-02 0.92540000E+00 0.17641036E-01 0.58823720E-02 0.58793645E-02 0.58792999E-02 0.92560000E+00 0.17610498E-01 0.58721888E-02 0.58691866E-02 0.58691226E-02 0.92580000E+00 0.17580049E-01 0.58620354E-02 0.58590384E-02 0.58589749E-02 0.92600000E+00 0.17549688E-01 0.58519115E-02 0.58489198E-02 0.58488568E-02 0.92620000E+00 0.17519416E-01 0.58418170E-02 0.58388306E-02 0.58387681E-02 0.92640000E+00 0.17489231E-01 0.58317519E-02 0.58287707E-02 0.58287088E-02 0.92660000E+00 0.17459135E-01 0.58217160E-02 0.58187400E-02 0.58186786E-02 0.92680000E+00 0.17429125E-01 0.58117092E-02 0.58087384E-02 0.58086775E-02 0.92700000E+00 0.17399203E-01 0.58017313E-02 0.57987658E-02 0.57987054E-02 0.92720000E+00 0.17369366E-01 0.57917824E-02 0.57888220E-02 0.57887621E-02 0.92740000E+00 0.17339617E-01 0.57818621E-02 0.57789069E-02 0.57788475E-02 0.92760000E+00 0.17309953E-01 0.57719705E-02 0.57690205E-02 0.57689616E-02 0.92780000E+00 0.17280374E-01 0.57621075E-02 0.57591625E-02 0.57591041E-02 0.92800000E+00 0.17250881E-01 0.57522728E-02 0.57493330E-02 0.57492751E-02 0.92820000E+00 0.17221472E-01 0.57424664E-02 0.57395317E-02 0.57394743E-02 0.92840000E+00 0.17192148E-01 0.57326881E-02 0.57297585E-02 0.57297016E-02 0.92860000E+00 0.17162908E-01 0.57229379E-02 0.57200134E-02 0.57199570E-02 0.92880000E+00 0.17133752E-01 0.57132157E-02 0.57102962E-02 0.57102403E-02 0.92900000E+00 0.17104680E-01 0.57035213E-02 0.57006069E-02 0.57005514E-02 0.92920000E+00 0.17075690E-01 0.56938546E-02 0.56909452E-02 0.56908903E-02 0.92940000E+00 0.17046783E-01 0.56842155E-02 0.56813112E-02 0.56812567E-02 0.92960000E+00 0.17017959E-01 0.56746039E-02 0.56717046E-02 0.56716506E-02 0.92980000E+00 0.16989217E-01 0.56650197E-02 0.56621254E-02 0.56620719E-02 0.93000000E+00 0.16960557E-01 0.56554628E-02 0.56525735E-02 0.56525204E-02 0.93020000E+00 0.16931978E-01 0.56459331E-02 0.56430487E-02 0.56429961E-02 0.93040000E+00 0.16903480E-01 0.56364304E-02 0.56335510E-02 0.56334988E-02 0.93060000E+00 0.16875063E-01 0.56269547E-02 0.56240802E-02 0.56240285E-02 0.93080000E+00 0.16846727E-01 0.56175058E-02 0.56146362E-02 0.56145850E-02 0.93100000E+00 0.16818471E-01 0.56080837E-02 0.56052190E-02 0.56051683E-02 0.93120000E+00 0.16790295E-01 0.55986882E-02 0.55958284E-02 0.55957781E-02 0.93140000E+00 0.16762198E-01 0.55893192E-02 0.55864643E-02 0.55864145E-02 0.93160000E+00 0.16734181E-01 0.55799767E-02 0.55771267E-02 0.55770773E-02 0.93180000E+00 0.16706242E-01 0.55706605E-02 0.55678153E-02 0.55677664E-02 0.93200000E+00 0.16678382E-01 0.55613705E-02 0.55585301E-02 0.55584817E-02 0.93220000E+00 0.16650601E-01 0.55521066E-02 0.55492711E-02 0.55492231E-02 0.93240000E+00 0.16622897E-01 0.55428688E-02 0.55400380E-02 0.55399905E-02 0.93260000E+00 0.16595271E-01 0.55336568E-02 0.55308309E-02 0.55307838E-02 0.93280000E+00 0.16567723E-01 0.55244707E-02 0.55216495E-02 0.55216029E-02 0.93300000E+00 0.16540252E-01 0.55153102E-02 0.55124939E-02 0.55124476E-02 0.93320000E+00 0.16512857E-01 0.55061754E-02 0.55033638E-02 0.55033180E-02 0.93340000E+00 0.16485539E-01 0.54970661E-02 0.54942592E-02 0.54942139E-02 0.93360000E+00 0.16458297E-01 0.54879822E-02 0.54851800E-02 0.54851351E-02 0.93380000E+00 0.16431131E-01 0.54789236E-02 0.54761261E-02 0.54760816E-02 0.93400000E+00 0.16404041E-01 0.54698902E-02 0.54670975E-02 0.54670534E-02 0.93420000E+00 0.16377026E-01 0.54608819E-02 0.54580939E-02 0.54580502E-02 0.93440000E+00 0.16350086E-01 0.54518986E-02 0.54491153E-02 0.54490721E-02 0.93460000E+00 0.16323221E-01 0.54429403E-02 0.54401616E-02 0.54401188E-02 0.93480000E+00 0.16296430E-01 0.54340067E-02 0.54312327E-02 0.54311903E-02 0.93500000E+00 0.16269713E-01 0.54250979E-02 0.54223286E-02 0.54222866E-02 0.93520000E+00 0.16243070E-01 0.54162138E-02 0.54134490E-02 0.54134075E-02 0.93540000E+00 0.16216501E-01 0.54073541E-02 0.54045940E-02 0.54045529E-02 0.93560000E+00 0.16190005E-01 0.53985189E-02 0.53957634E-02 0.53957227E-02 0.93580000E+00 0.16163582E-01 0.53897081E-02 0.53869571E-02 0.53869168E-02 0.93600000E+00 0.16137232E-01 0.53809215E-02 0.53781751E-02 0.53781352E-02 0.93620000E+00 0.16110954E-01 0.53721590E-02 0.53694172E-02 0.53693777E-02 0.93640000E+00 0.16084748E-01 0.53634206E-02 0.53606834E-02 0.53606443E-02 0.93660000E+00 0.16058614E-01 0.53547062E-02 0.53519735E-02 0.53519348E-02 0.93680000E+00 0.16032552E-01 0.53460157E-02 0.53432875E-02 0.53432492E-02 0.93700000E+00 0.16006562E-01 0.53373489E-02 0.53346252E-02 0.53345874E-02 0.93720000E+00 0.15980642E-01 0.53287059E-02 0.53259867E-02 0.53259492E-02 0.93740000E+00 0.15954793E-01 0.53200864E-02 0.53173717E-02 0.53173347E-02 0.93760000E+00 0.15929014E-01 0.53114905E-02 0.53087803E-02 0.53087436E-02 0.93780000E+00 0.15903306E-01 0.53029180E-02 0.53002123E-02 0.53001760E-02 0.93800000E+00 0.15877668E-01 0.52943689E-02 0.52916676E-02 0.52916316E-02 0.93820000E+00 0.15852100E-01 0.52858430E-02 0.52831461E-02 0.52831106E-02 0.93840000E+00 0.15826601E-01 0.52773402E-02 0.52746478E-02 0.52746126E-02 0.93860000E+00 0.15801171E-01 0.52688605E-02 0.52661725E-02 0.52661378E-02 0.93880000E+00 0.15775810E-01 0.52604039E-02 0.52577202E-02 0.52576858E-02 0.93900000E+00 0.15750518E-01 0.52519701E-02 0.52492908E-02 0.52492568E-02 0.93920000E+00 0.15725294E-01 0.52435591E-02 0.52408842E-02 0.52408506E-02 0.93940000E+00 0.15700138E-01 0.52351708E-02 0.52325004E-02 0.52324671E-02 0.93960000E+00 0.15675051E-01 0.52268052E-02 0.52241391E-02 0.52241062E-02 0.93980000E+00 0.15650030E-01 0.52184622E-02 0.52158004E-02 0.52157679E-02 0.94000000E+00 0.15625078E-01 0.52101416E-02 0.52074841E-02 0.52074520E-02 0.94020000E+00 0.15600192E-01 0.52018434E-02 0.51991902E-02 0.51991585E-02 0.94040000E+00 0.15575373E-01 0.51935674E-02 0.51909186E-02 0.51908872E-02 0.94060000E+00 0.15550621E-01 0.51853138E-02 0.51826692E-02 0.51826382E-02 0.94080000E+00 0.15525935E-01 0.51770822E-02 0.51744420E-02 0.51744113E-02 0.94100000E+00 0.15501316E-01 0.51688727E-02 0.51662367E-02 0.51662064E-02 0.94120000E+00 0.15476762E-01 0.51606851E-02 0.51580534E-02 0.51580235E-02 0.94140000E+00 0.15452274E-01 0.51525195E-02 0.51498920E-02 0.51498624E-02 0.94160000E+00 0.15427851E-01 0.51443756E-02 0.51417524E-02 0.51417232E-02 0.94180000E+00 0.15403494E-01 0.51362535E-02 0.51336345E-02 0.51336056E-02 0.94200000E+00 0.15379201E-01 0.51281530E-02 0.51255383E-02 0.51255097E-02 0.94220000E+00 0.15354973E-01 0.51200741E-02 0.51174635E-02 0.51174353E-02 0.94240000E+00 0.15330809E-01 0.51120166E-02 0.51094103E-02 0.51093824E-02 0.94260000E+00 0.15306710E-01 0.51039806E-02 0.51013784E-02 0.51013509E-02 0.94280000E+00 0.15282674E-01 0.50959658E-02 0.50933679E-02 0.50933407E-02 0.94300000E+00 0.15258703E-01 0.50879724E-02 0.50853785E-02 0.50853517E-02 0.94320000E+00 0.15234794E-01 0.50800000E-02 0.50774104E-02 0.50773839E-02 0.94340000E+00 0.15210949E-01 0.50720488E-02 0.50694632E-02 0.50694371E-02 0.94360000E+00 0.15187167E-01 0.50641186E-02 0.50615371E-02 0.50615114E-02 0.94380000E+00 0.15163448E-01 0.50562092E-02 0.50536320E-02 0.50536065E-02 0.94400000E+00 0.15139791E-01 0.50483208E-02 0.50457476E-02 0.50457225E-02 0.94420000E+00 0.15116196E-01 0.50404531E-02 0.50378840E-02 0.50378593E-02 0.94440000E+00 0.15092664E-01 0.50326061E-02 0.50300411E-02 0.50300167E-02 0.94460000E+00 0.15069193E-01 0.50247798E-02 0.50222188E-02 0.50221947E-02 0.94480000E+00 0.15045784E-01 0.50169740E-02 0.50144171E-02 0.50143933E-02 0.94500000E+00 0.15022437E-01 0.50091886E-02 0.50066358E-02 0.50066124E-02 0.94520000E+00 0.14999150E-01 0.50014237E-02 0.49988749E-02 0.49988518E-02 0.94540000E+00 0.14975925E-01 0.49936790E-02 0.49911343E-02 0.49911115E-02 0.94560000E+00 0.14952760E-01 0.49859547E-02 0.49834140E-02 0.49833915E-02 0.94580000E+00 0.14929656E-01 0.49782505E-02 0.49757138E-02 0.49756916E-02 0.94600000E+00 0.14906612E-01 0.49705664E-02 0.49680337E-02 0.49680118E-02 0.94620000E+00 0.14883628E-01 0.49629023E-02 0.49603736E-02 0.49603521E-02 0.94640000E+00 0.14860704E-01 0.49552582E-02 0.49527334E-02 0.49527122E-02 0.94660000E+00 0.14837839E-01 0.49476339E-02 0.49451131E-02 0.49450923E-02 0.94680000E+00 0.14815034E-01 0.49400295E-02 0.49375127E-02 0.49374921E-02 0.94700000E+00 0.14792288E-01 0.49324448E-02 0.49299319E-02 0.49299117E-02 0.94720000E+00 0.14769601E-01 0.49248797E-02 0.49223708E-02 0.49223509E-02 0.94740000E+00 0.14746973E-01 0.49173343E-02 0.49148293E-02 0.49148097E-02 0.94760000E+00 0.14724404E-01 0.49098084E-02 0.49073073E-02 0.49072880E-02 0.94780000E+00 0.14701892E-01 0.49023019E-02 0.48998047E-02 0.48997857E-02 0.94800000E+00 0.14679439E-01 0.48948148E-02 0.48923215E-02 0.48923028E-02 0.94820000E+00 0.14657044E-01 0.48873470E-02 0.48848577E-02 0.48848392E-02 0.94840000E+00 0.14634706E-01 0.48798985E-02 0.48774130E-02 0.48773949E-02 0.94860000E+00 0.14612426E-01 0.48724691E-02 0.48699875E-02 0.48699697E-02 0.94880000E+00 0.14590204E-01 0.48650589E-02 0.48625811E-02 0.48625636E-02 0.94900000E+00 0.14568038E-01 0.48576676E-02 0.48551937E-02 0.48551765E-02 0.94920000E+00 0.14545929E-01 0.48502954E-02 0.48478253E-02 0.48478084E-02 0.94940000E+00 0.14523877E-01 0.48429420E-02 0.48404758E-02 0.48404591E-02 0.94960000E+00 0.14501881E-01 0.48356075E-02 0.48331450E-02 0.48331287E-02 0.94980000E+00 0.14479942E-01 0.48282917E-02 0.48258331E-02 0.48258171E-02 0.95000000E+00 0.14458059E-01 0.48209946E-02 0.48185398E-02 0.48185241E-02 0.95020000E+00 0.14436231E-01 0.48137162E-02 0.48112652E-02 0.48112497E-02 0.95040000E+00 0.14414459E-01 0.48064563E-02 0.48040091E-02 0.48039939E-02 0.95060000E+00 0.14392743E-01 0.47992149E-02 0.47967714E-02 0.47967566E-02 0.95080000E+00 0.14371082E-01 0.47919920E-02 0.47895522E-02 0.47895377E-02 0.95100000E+00 0.14349476E-01 0.47847874E-02 0.47823514E-02 0.47823371E-02 0.95120000E+00 0.14327925E-01 0.47776011E-02 0.47751689E-02 0.47751548E-02 0.95140000E+00 0.14306428E-01 0.47704330E-02 0.47680045E-02 0.47679908E-02 0.95160000E+00 0.14284986E-01 0.47632832E-02 0.47608584E-02 0.47608449E-02 0.95180000E+00 0.14263599E-01 0.47561514E-02 0.47537303E-02 0.47537171E-02 0.95200000E+00 0.14242265E-01 0.47490376E-02 0.47466203E-02 0.47466074E-02 0.95220000E+00 0.14220986E-01 0.47419419E-02 0.47395282E-02 0.47395156E-02 0.95240000E+00 0.14199760E-01 0.47348640E-02 0.47324540E-02 0.47324417E-02 0.95260000E+00 0.14178587E-01 0.47278040E-02 0.47253977E-02 0.47253856E-02 0.95280000E+00 0.14157468E-01 0.47207618E-02 0.47183592E-02 0.47183474E-02 0.95300000E+00 0.14136403E-01 0.47137374E-02 0.47113384E-02 0.47113268E-02 0.95320000E+00 0.14115390E-01 0.47067305E-02 0.47043352E-02 0.47043239E-02 0.95340000E+00 0.14094430E-01 0.46997413E-02 0.46973496E-02 0.46973386E-02 0.95360000E+00 0.14073522E-01 0.46927696E-02 0.46903816E-02 0.46903708E-02 0.95380000E+00 0.14052667E-01 0.46858154E-02 0.46834310E-02 0.46834205E-02 0.95400000E+00 0.14031864E-01 0.46788787E-02 0.46764978E-02 0.46764876E-02 0.95420000E+00 0.14011113E-01 0.46719592E-02 0.46695820E-02 0.46695720E-02 0.95440000E+00 0.13990414E-01 0.46650571E-02 0.46626834E-02 0.46626738E-02 0.95460000E+00 0.13969767E-01 0.46581722E-02 0.46558021E-02 0.46557927E-02 0.95480000E+00 0.13949171E-01 0.46513045E-02 0.46489380E-02 0.46489288E-02 0.95500000E+00 0.13928627E-01 0.46444539E-02 0.46420909E-02 0.46420820E-02 0.95520000E+00 0.13908133E-01 0.46376203E-02 0.46352609E-02 0.46352523E-02 0.95540000E+00 0.13887691E-01 0.46308037E-02 0.46284479E-02 0.46284395E-02 0.95560000E+00 0.13867300E-01 0.46240041E-02 0.46216518E-02 0.46216437E-02 0.95580000E+00 0.13846959E-01 0.46172214E-02 0.46148726E-02 0.46148647E-02 0.95600000E+00 0.13826668E-01 0.46104554E-02 0.46081102E-02 0.46081026E-02 0.95620000E+00 0.13806428E-01 0.46037063E-02 0.46013645E-02 0.46013571E-02 0.95640000E+00 0.13786238E-01 0.45969738E-02 0.45946355E-02 0.45946284E-02 0.95660000E+00 0.13766098E-01 0.45902580E-02 0.45879232E-02 0.45879163E-02 0.95680000E+00 0.13746007E-01 0.45835587E-02 0.45812275E-02 0.45812208E-02 0.95700000E+00 0.13725966E-01 0.45768760E-02 0.45745482E-02 0.45745419E-02 0.95720000E+00 0.13705975E-01 0.45702098E-02 0.45678855E-02 0.45678793E-02 0.95740000E+00 0.13686032E-01 0.45635600E-02 0.45612391E-02 0.45612332E-02 0.95760000E+00 0.13666139E-01 0.45569265E-02 0.45546091E-02 0.45546035E-02 0.95780000E+00 0.13646295E-01 0.45503093E-02 0.45479954E-02 0.45479900E-02 0.95800000E+00 0.13626499E-01 0.45437084E-02 0.45413979E-02 0.45413927E-02 0.95820000E+00 0.13606752E-01 0.45371237E-02 0.45348166E-02 0.45348117E-02 0.95840000E+00 0.13587053E-01 0.45305551E-02 0.45282514E-02 0.45282468E-02 0.95860000E+00 0.13567403E-01 0.45240026E-02 0.45217023E-02 0.45216979E-02 0.95880000E+00 0.13547800E-01 0.45174661E-02 0.45151693E-02 0.45151651E-02 0.95900000E+00 0.13528246E-01 0.45109456E-02 0.45086522E-02 0.45086482E-02 0.95920000E+00 0.13508739E-01 0.45044410E-02 0.45021509E-02 0.45021472E-02 0.95940000E+00 0.13489280E-01 0.44979523E-02 0.44956656E-02 0.44956621E-02 0.95960000E+00 0.13469868E-01 0.44914794E-02 0.44891960E-02 0.44891928E-02 0.95980000E+00 0.13450504E-01 0.44850222E-02 0.44827422E-02 0.44827392E-02 0.96000000E+00 0.13431186E-01 0.44785808E-02 0.44763041E-02 0.44763013E-02 0.96020000E+00 0.13411916E-01 0.44721549E-02 0.44698816E-02 0.44698791E-02 0.96040000E+00 0.13392692E-01 0.44657447E-02 0.44634747E-02 0.44634724E-02 0.96060000E+00 0.13373515E-01 0.44593500E-02 0.44570834E-02 0.44570813E-02 0.96080000E+00 0.13354384E-01 0.44529708E-02 0.44507075E-02 0.44507056E-02 0.96100000E+00 0.13335299E-01 0.44466071E-02 0.44443470E-02 0.44443454E-02 0.96120000E+00 0.13316261E-01 0.44402587E-02 0.44380020E-02 0.44380005E-02 0.96140000E+00 0.13297269E-01 0.44339256E-02 0.44316722E-02 0.44316710E-02 0.96160000E+00 0.13278322E-01 0.44276079E-02 0.44253577E-02 0.44253567E-02 0.96180000E+00 0.13259421E-01 0.44213053E-02 0.44190585E-02 0.44190577E-02 0.96200000E+00 0.13240566E-01 0.44150180E-02 0.44127744E-02 0.44127738E-02 0.96220000E+00 0.13221756E-01 0.44087457E-02 0.44065054E-02 0.44065051E-02 0.96240000E+00 0.13202991E-01 0.44024886E-02 0.44002515E-02 0.44002514E-02 0.96260000E+00 0.13184272E-01 0.43962464E-02 0.43940126E-02 0.43940127E-02 0.96280000E+00 0.13165597E-01 0.43900193E-02 0.43877887E-02 0.43877890E-02 0.96300000E+00 0.13146967E-01 0.43838070E-02 0.43815797E-02 0.43815802E-02 0.96320000E+00 0.13128381E-01 0.43776096E-02 0.43753855E-02 0.43753862E-02 0.96340000E+00 0.13109840E-01 0.43714271E-02 0.43692062E-02 0.43692071E-02 0.96360000E+00 0.13091344E-01 0.43652593E-02 0.43630416E-02 0.43630428E-02 0.96380000E+00 0.13072891E-01 0.43591063E-02 0.43568918E-02 0.43568931E-02 0.96400000E+00 0.13054483E-01 0.43529679E-02 0.43507566E-02 0.43507582E-02 0.96420000E+00 0.13036118E-01 0.43468442E-02 0.43446360E-02 0.43446378E-02 0.96440000E+00 0.13017797E-01 0.43407350E-02 0.43385300E-02 0.43385320E-02 0.96460000E+00 0.12999520E-01 0.43346404E-02 0.43324386E-02 0.43324408E-02 0.96480000E+00 0.12981286E-01 0.43285602E-02 0.43263616E-02 0.43263640E-02 0.96500000E+00 0.12963095E-01 0.43224945E-02 0.43202990E-02 0.43203016E-02 0.96520000E+00 0.12944948E-01 0.43164431E-02 0.43142508E-02 0.43142536E-02 0.96540000E+00 0.12926843E-01 0.43104061E-02 0.43082170E-02 0.43082200E-02 0.96560000E+00 0.12908781E-01 0.43043834E-02 0.43021974E-02 0.43022006E-02 0.96580000E+00 0.12890762E-01 0.42983750E-02 0.42961920E-02 0.42961955E-02 0.96600000E+00 0.12872786E-01 0.42923807E-02 0.42902009E-02 0.42902045E-02 0.96620000E+00 0.12854852E-01 0.42864006E-02 0.42842239E-02 0.42842277E-02 0.96640000E+00 0.12836960E-01 0.42804346E-02 0.42782610E-02 0.42782650E-02 0.96660000E+00 0.12819111E-01 0.42744826E-02 0.42723121E-02 0.42723163E-02 0.96680000E+00 0.12801303E-01 0.42685446E-02 0.42663772E-02 0.42663816E-02 0.96700000E+00 0.12783538E-01 0.42626206E-02 0.42604563E-02 0.42604609E-02 0.96720000E+00 0.12765814E-01 0.42567106E-02 0.42545493E-02 0.42545541E-02 0.96740000E+00 0.12748132E-01 0.42508144E-02 0.42486562E-02 0.42486612E-02 0.96760000E+00 0.12730491E-01 0.42449320E-02 0.42427768E-02 0.42427820E-02 0.96780000E+00 0.12712891E-01 0.42390634E-02 0.42369113E-02 0.42369167E-02 0.96800000E+00 0.12695333E-01 0.42332085E-02 0.42310595E-02 0.42310650E-02 0.96820000E+00 0.12677816E-01 0.42273673E-02 0.42252213E-02 0.42252271E-02 0.96840000E+00 0.12660339E-01 0.42215398E-02 0.42193968E-02 0.42194028E-02 0.96860000E+00 0.12642904E-01 0.42157259E-02 0.42135859E-02 0.42135921E-02 0.96880000E+00 0.12625509E-01 0.42099255E-02 0.42077886E-02 0.42077949E-02 0.96900000E+00 0.12608155E-01 0.42041387E-02 0.42020047E-02 0.42020112E-02 0.96920000E+00 0.12590841E-01 0.41983653E-02 0.41962343E-02 0.41962410E-02 0.96940000E+00 0.12573567E-01 0.41926053E-02 0.41904774E-02 0.41904843E-02 0.96960000E+00 0.12556333E-01 0.41868587E-02 0.41847338E-02 0.41847408E-02 0.96980000E+00 0.12539140E-01 0.41811255E-02 0.41790035E-02 0.41790108E-02 0.97000000E+00 0.12521986E-01 0.41754055E-02 0.41732865E-02 0.41732940E-02 0.97020000E+00 0.12504872E-01 0.41696988E-02 0.41675828E-02 0.41675904E-02 0.97040000E+00 0.12487798E-01 0.41640053E-02 0.41618923E-02 0.41619001E-02 0.97060000E+00 0.12470763E-01 0.41583250E-02 0.41562149E-02 0.41562229E-02 0.97080000E+00 0.12453767E-01 0.41526578E-02 0.41505506E-02 0.41505588E-02 0.97100000E+00 0.12436811E-01 0.41470037E-02 0.41448995E-02 0.41449078E-02 0.97120000E+00 0.12419894E-01 0.41413626E-02 0.41392613E-02 0.41392698E-02 0.97140000E+00 0.12403016E-01 0.41357345E-02 0.41336361E-02 0.41336448E-02 0.97160000E+00 0.12386176E-01 0.41301194E-02 0.41280239E-02 0.41280328E-02 0.97180000E+00 0.12369375E-01 0.41245172E-02 0.41224246E-02 0.41224337E-02 0.97200000E+00 0.12352613E-01 0.41189278E-02 0.41168382E-02 0.41168474E-02 0.97220000E+00 0.12335890E-01 0.41133513E-02 0.41112646E-02 0.41112740E-02 0.97240000E+00 0.12319205E-01 0.41077876E-02 0.41057037E-02 0.41057133E-02 0.97260000E+00 0.12302558E-01 0.41022366E-02 0.41001556E-02 0.41001654E-02 0.97280000E+00 0.12285949E-01 0.40966983E-02 0.40946202E-02 0.40946301E-02 0.97300000E+00 0.12269378E-01 0.40911727E-02 0.40890975E-02 0.40891076E-02 0.97320000E+00 0.12252845E-01 0.40856597E-02 0.40835874E-02 0.40835976E-02 0.97340000E+00 0.12236349E-01 0.40801593E-02 0.40780898E-02 0.40781003E-02 0.97360000E+00 0.12219892E-01 0.40746715E-02 0.40726048E-02 0.40726154E-02 0.97380000E+00 0.12203472E-01 0.40691962E-02 0.40671323E-02 0.40671431E-02 0.97400000E+00 0.12187089E-01 0.40637333E-02 0.40616723E-02 0.40616832E-02 0.97420000E+00 0.12170743E-01 0.40582828E-02 0.40562247E-02 0.40562358E-02 0.97440000E+00 0.12154435E-01 0.40528447E-02 0.40507894E-02 0.40508007E-02 0.97460000E+00 0.12138164E-01 0.40474190E-02 0.40453665E-02 0.40453779E-02 0.97480000E+00 0.12121929E-01 0.40420056E-02 0.40399559E-02 0.40399675E-02 0.97500000E+00 0.12105731E-01 0.40366045E-02 0.40345576E-02 0.40345693E-02 0.97520000E+00 0.12089570E-01 0.40312156E-02 0.40291715E-02 0.40291834E-02 0.97540000E+00 0.12073446E-01 0.40258388E-02 0.40237975E-02 0.40238096E-02 0.97560000E+00 0.12057358E-01 0.40204743E-02 0.40184358E-02 0.40184480E-02 0.97580000E+00 0.12041306E-01 0.40151218E-02 0.40130861E-02 0.40130985E-02 0.97600000E+00 0.12025291E-01 0.40097814E-02 0.40077485E-02 0.40077610E-02 0.97620000E+00 0.12009312E-01 0.40044531E-02 0.40024229E-02 0.40024356E-02 0.97640000E+00 0.11993368E-01 0.39991367E-02 0.39971093E-02 0.39971222E-02 0.97660000E+00 0.11977461E-01 0.39938324E-02 0.39918077E-02 0.39918207E-02 0.97680000E+00 0.11961589E-01 0.39885399E-02 0.39865180E-02 0.39865312E-02 0.97700000E+00 0.11945753E-01 0.39832593E-02 0.39812402E-02 0.39812535E-02 0.97720000E+00 0.11929952E-01 0.39779906E-02 0.39759742E-02 0.39759877E-02 0.97740000E+00 0.11914187E-01 0.39727337E-02 0.39707200E-02 0.39707336E-02 0.97760000E+00 0.11898458E-01 0.39674886E-02 0.39654776E-02 0.39654914E-02 0.97780000E+00 0.11882763E-01 0.39622552E-02 0.39602469E-02 0.39602609E-02 0.97800000E+00 0.11867103E-01 0.39570335E-02 0.39550279E-02 0.39550420E-02 0.97820000E+00 0.11851479E-01 0.39518234E-02 0.39498206E-02 0.39498349E-02 0.97840000E+00 0.11835889E-01 0.39466251E-02 0.39446249E-02 0.39446393E-02 0.97860000E+00 0.11820334E-01 0.39414382E-02 0.39394408E-02 0.39394553E-02 0.97880000E+00 0.11804814E-01 0.39362630E-02 0.39342682E-02 0.39342829E-02 0.97900000E+00 0.11789328E-01 0.39310993E-02 0.39291072E-02 0.39291220E-02 0.97920000E+00 0.11773877E-01 0.39259470E-02 0.39239576E-02 0.39239726E-02 0.97940000E+00 0.11758460E-01 0.39208062E-02 0.39188195E-02 0.39188346E-02 0.97960000E+00 0.11743078E-01 0.39156768E-02 0.39136928E-02 0.39137081E-02 0.97980000E+00 0.11727729E-01 0.39105588E-02 0.39085774E-02 0.39085929E-02 0.98000000E+00 0.11712415E-01 0.39054522E-02 0.39034734E-02 0.39034890E-02 0.98020000E+00 0.11697134E-01 0.39003568E-02 0.38983807E-02 0.38983964E-02 0.98040000E+00 0.11681887E-01 0.38952727E-02 0.38932993E-02 0.38933151E-02 0.98060000E+00 0.11666674E-01 0.38901999E-02 0.38882291E-02 0.38882451E-02 0.98080000E+00 0.11651494E-01 0.38851383E-02 0.38831700E-02 0.38831862E-02 0.98100000E+00 0.11636348E-01 0.38800878E-02 0.38781222E-02 0.38781385E-02 0.98120000E+00 0.11621236E-01 0.38750484E-02 0.38730855E-02 0.38731019E-02 0.98140000E+00 0.11606156E-01 0.38700202E-02 0.38680598E-02 0.38680764E-02 0.98160000E+00 0.11591110E-01 0.38650030E-02 0.38630453E-02 0.38630620E-02 0.98180000E+00 0.11576097E-01 0.38599969E-02 0.38580417E-02 0.38580586E-02 0.98200000E+00 0.11561117E-01 0.38550017E-02 0.38530492E-02 0.38530662E-02 0.98220000E+00 0.11546170E-01 0.38500176E-02 0.38480676E-02 0.38480847E-02 0.98240000E+00 0.11531255E-01 0.38450443E-02 0.38430969E-02 0.38431142E-02 0.98260000E+00 0.11516374E-01 0.38400819E-02 0.38381371E-02 0.38381545E-02 0.98280000E+00 0.11501524E-01 0.38351304E-02 0.38331882E-02 0.38332057E-02 0.98300000E+00 0.11486708E-01 0.38301898E-02 0.38282501E-02 0.38282678E-02 0.98320000E+00 0.11471923E-01 0.38252599E-02 0.38233228E-02 0.38233406E-02 0.98340000E+00 0.11457171E-01 0.38203408E-02 0.38184062E-02 0.38184242E-02 0.98360000E+00 0.11442451E-01 0.38154324E-02 0.38135004E-02 0.38135185E-02 0.98380000E+00 0.11427764E-01 0.38105348E-02 0.38086053E-02 0.38086235E-02 0.98400000E+00 0.11413108E-01 0.38056478E-02 0.38037208E-02 0.38037392E-02 0.98420000E+00 0.11398484E-01 0.38007714E-02 0.37988470E-02 0.37988654E-02 0.98440000E+00 0.11383892E-01 0.37959056E-02 0.37939837E-02 0.37940023E-02 0.98460000E+00 0.11369331E-01 0.37910504E-02 0.37891310E-02 0.37891498E-02 0.98480000E+00 0.11354802E-01 0.37862057E-02 0.37842889E-02 0.37843077E-02 0.98500000E+00 0.11340305E-01 0.37813716E-02 0.37794572E-02 0.37794762E-02 0.98520000E+00 0.11325839E-01 0.37765479E-02 0.37746360E-02 0.37746551E-02 0.98540000E+00 0.11311404E-01 0.37717346E-02 0.37698253E-02 0.37698445E-02 0.98560000E+00 0.11297001E-01 0.37669318E-02 0.37650249E-02 0.37650443E-02 0.98580000E+00 0.11282629E-01 0.37621393E-02 0.37602349E-02 0.37602544E-02 0.98600000E+00 0.11268287E-01 0.37573572E-02 0.37554553E-02 0.37554749E-02 0.98620000E+00 0.11253977E-01 0.37525854E-02 0.37506860E-02 0.37507057E-02 0.98640000E+00 0.11239698E-01 0.37478238E-02 0.37459269E-02 0.37459468E-02 0.98660000E+00 0.11225449E-01 0.37430726E-02 0.37411781E-02 0.37411981E-02 0.98680000E+00 0.11211231E-01 0.37383315E-02 0.37364395E-02 0.37364597E-02 0.98700000E+00 0.11197043E-01 0.37336007E-02 0.37317111E-02 0.37317314E-02 0.98720000E+00 0.11182886E-01 0.37288800E-02 0.37269929E-02 0.37270133E-02 0.98740000E+00 0.11168759E-01 0.37241694E-02 0.37222848E-02 0.37223053E-02 0.98760000E+00 0.11154663E-01 0.37194690E-02 0.37175867E-02 0.37176074E-02 0.98780000E+00 0.11140597E-01 0.37147786E-02 0.37128988E-02 0.37129195E-02 0.98800000E+00 0.11126561E-01 0.37100982E-02 0.37082208E-02 0.37082417E-02 0.98820000E+00 0.11112555E-01 0.37054279E-02 0.37035529E-02 0.37035739E-02 0.98840000E+00 0.11098579E-01 0.37007675E-02 0.36988950E-02 0.36989161E-02 0.98860000E+00 0.11084632E-01 0.36961171E-02 0.36942470E-02 0.36942682E-02 0.98880000E+00 0.11070716E-01 0.36914766E-02 0.36896089E-02 0.36896302E-02 0.98900000E+00 0.11056829E-01 0.36868460E-02 0.36849807E-02 0.36850022E-02 0.98920000E+00 0.11042971E-01 0.36822252E-02 0.36803623E-02 0.36803839E-02 0.98940000E+00 0.11029144E-01 0.36776143E-02 0.36757538E-02 0.36757755E-02 0.98960000E+00 0.11015345E-01 0.36730132E-02 0.36711551E-02 0.36711769E-02 0.98980000E+00 0.11001576E-01 0.36684219E-02 0.36665661E-02 0.36665881E-02 0.99000000E+00 0.10987836E-01 0.36638403E-02 0.36619869E-02 0.36620090E-02 0.99020000E+00 0.10974125E-01 0.36592684E-02 0.36574174E-02 0.36574396E-02 0.99040000E+00 0.10960444E-01 0.36547062E-02 0.36528576E-02 0.36528799E-02 0.99060000E+00 0.10946791E-01 0.36501537E-02 0.36483074E-02 0.36483298E-02 0.99080000E+00 0.10933167E-01 0.36456108E-02 0.36437669E-02 0.36437894E-02 0.99100000E+00 0.10919572E-01 0.36410775E-02 0.36392359E-02 0.36392585E-02 0.99120000E+00 0.10906006E-01 0.36365537E-02 0.36347145E-02 0.36347373E-02 0.99140000E+00 0.10892468E-01 0.36320396E-02 0.36302027E-02 0.36302255E-02 0.99160000E+00 0.10878959E-01 0.36275349E-02 0.36257003E-02 0.36257233E-02 0.99180000E+00 0.10865478E-01 0.36230397E-02 0.36212075E-02 0.36212306E-02 0.99200000E+00 0.10852025E-01 0.36185540E-02 0.36167241E-02 0.36167473E-02 0.99220000E+00 0.10838601E-01 0.36140777E-02 0.36122501E-02 0.36122734E-02 0.99240000E+00 0.10825205E-01 0.36096108E-02 0.36077856E-02 0.36078090E-02 0.99260000E+00 0.10811838E-01 0.36051533E-02 0.36033304E-02 0.36033539E-02 0.99280000E+00 0.10798498E-01 0.36007051E-02 0.35988845E-02 0.35989081E-02 0.99300000E+00 0.10785186E-01 0.35962663E-02 0.35944480E-02 0.35944717E-02 0.99320000E+00 0.10771902E-01 0.35918367E-02 0.35900207E-02 0.35900445E-02 0.99340000E+00 0.10758646E-01 0.35874165E-02 0.35856027E-02 0.35856267E-02 0.99360000E+00 0.10745417E-01 0.35830054E-02 0.35811940E-02 0.35812180E-02 0.99380000E+00 0.10732217E-01 0.35786036E-02 0.35767944E-02 0.35768186E-02 0.99400000E+00 0.10719043E-01 0.35742110E-02 0.35724041E-02 0.35724283E-02 0.99420000E+00 0.10705898E-01 0.35698275E-02 0.35680229E-02 0.35680472E-02 0.99440000E+00 0.10692779E-01 0.35654531E-02 0.35636508E-02 0.35636753E-02 0.99460000E+00 0.10679688E-01 0.35610879E-02 0.35592878E-02 0.35593124E-02 0.99480000E+00 0.10666624E-01 0.35567317E-02 0.35549339E-02 0.35549586E-02 0.99500000E+00 0.10653588E-01 0.35523846E-02 0.35505891E-02 0.35506138E-02 0.99520000E+00 0.10640578E-01 0.35480466E-02 0.35462532E-02 0.35462781E-02 0.99540000E+00 0.10627595E-01 0.35437175E-02 0.35419264E-02 0.35419514E-02 0.99560000E+00 0.10614639E-01 0.35393974E-02 0.35376085E-02 0.35376336E-02 0.99580000E+00 0.10601711E-01 0.35350862E-02 0.35332996E-02 0.35333248E-02 0.99600000E+00 0.10588808E-01 0.35307840E-02 0.35289996E-02 0.35290249E-02 0.99620000E+00 0.10575933E-01 0.35264906E-02 0.35247085E-02 0.35247339E-02 0.99640000E+00 0.10563084E-01 0.35222062E-02 0.35204262E-02 0.35204517E-02 0.99660000E+00 0.10550262E-01 0.35179306E-02 0.35161528E-02 0.35161784E-02 0.99680000E+00 0.10537466E-01 0.35136638E-02 0.35118883E-02 0.35119139E-02 0.99700000E+00 0.10524696E-01 0.35094058E-02 0.35076325E-02 0.35076582E-02 0.99720000E+00 0.10511953E-01 0.35051565E-02 0.35033854E-02 0.35034113E-02 0.99740000E+00 0.10499236E-01 0.35009160E-02 0.34991471E-02 0.34991731E-02 0.99760000E+00 0.10486545E-01 0.34966842E-02 0.34949175E-02 0.34949436E-02 0.99780000E+00 0.10473881E-01 0.34924612E-02 0.34906967E-02 0.34907228E-02 0.99800000E+00 0.10461242E-01 0.34882468E-02 0.34864844E-02 0.34865107E-02 0.99820000E+00 0.10448629E-01 0.34840410E-02 0.34822808E-02 0.34823072E-02 0.99840000E+00 0.10436042E-01 0.34798438E-02 0.34780859E-02 0.34781123E-02 0.99860000E+00 0.10423481E-01 0.34756553E-02 0.34738995E-02 0.34739260E-02 0.99880000E+00 0.10410945E-01 0.34714753E-02 0.34697217E-02 0.34697483E-02 0.99900000E+00 0.10398435E-01 0.34673039E-02 0.34655524E-02 0.34655791E-02 0.99920000E+00 0.10385951E-01 0.34631410E-02 0.34613916E-02 0.34614185E-02 0.99940000E+00 0.10373492E-01 0.34589865E-02 0.34572394E-02 0.34572663E-02 0.99960000E+00 0.10361059E-01 0.34548406E-02 0.34530956E-02 0.34531226E-02 0.99980000E+00 0.10348651E-01 0.34507031E-02 0.34489602E-02 0.34489873E-02 0.10000000E+01 0.10336268E-01 0.34465740E-02 0.34448333E-02 0.34448605E-02 0.10002000E+01 0.10323910E-01 0.34424533E-02 0.34407147E-02 0.34407420E-02 0.10004000E+01 0.10311578E-01 0.34383410E-02 0.34366046E-02 0.34366319E-02 0.10006000E+01 0.10299270E-01 0.34342371E-02 0.34325027E-02 0.34325302E-02 0.10008000E+01 0.10286987E-01 0.34301415E-02 0.34284092E-02 0.34284368E-02 0.10010000E+01 0.10274730E-01 0.34260541E-02 0.34243240E-02 0.34243517E-02 0.10012000E+01 0.10262497E-01 0.34219751E-02 0.34202471E-02 0.34202749E-02 0.10014000E+01 0.10250289E-01 0.34179043E-02 0.34161785E-02 0.34162063E-02 0.10016000E+01 0.10238106E-01 0.34138418E-02 0.34121180E-02 0.34121459E-02 0.10018000E+01 0.10225947E-01 0.34097875E-02 0.34080658E-02 0.34080938E-02 0.10020000E+01 0.10213813E-01 0.34057413E-02 0.34040217E-02 0.34040498E-02 0.10022000E+01 0.10201703E-01 0.34017034E-02 0.33999859E-02 0.34000140E-02 0.10024000E+01 0.10189618E-01 0.33976735E-02 0.33959581E-02 0.33959864E-02 0.10026000E+01 0.10177557E-01 0.33936518E-02 0.33919385E-02 0.33919668E-02 0.10028000E+01 0.10165521E-01 0.33896382E-02 0.33879269E-02 0.33879554E-02 0.10030000E+01 0.10153508E-01 0.33856326E-02 0.33839235E-02 0.33839520E-02 0.10032000E+01 0.10141520E-01 0.33816351E-02 0.33799280E-02 0.33799567E-02 0.10034000E+01 0.10129556E-01 0.33776457E-02 0.33759406E-02 0.33759693E-02 0.10036000E+01 0.10117615E-01 0.33736642E-02 0.33719612E-02 0.33719900E-02 0.10038000E+01 0.10105699E-01 0.33696907E-02 0.33679898E-02 0.33680187E-02 0.10040000E+01 0.10093807E-01 0.33657252E-02 0.33640264E-02 0.33640553E-02 0.10042000E+01 0.10081938E-01 0.33617676E-02 0.33600708E-02 0.33600999E-02 0.10044000E+01 0.10070094E-01 0.33578180E-02 0.33561232E-02 0.33561523E-02 0.10046000E+01 0.10058272E-01 0.33538762E-02 0.33521835E-02 0.33522127E-02 0.10048000E+01 0.10046475E-01 0.33499423E-02 0.33482516E-02 0.33482809E-02 0.10050000E+01 0.10034701E-01 0.33460163E-02 0.33443276E-02 0.33443570E-02 0.10052000E+01 0.10022950E-01 0.33420981E-02 0.33404114E-02 0.33404409E-02 0.10054000E+01 0.10011223E-01 0.33381876E-02 0.33365030E-02 0.33365326E-02 0.10056000E+01 0.99995195E-02 0.33342850E-02 0.33326024E-02 0.33326320E-02 0.10058000E+01 0.99878390E-02 0.33303901E-02 0.33287096E-02 0.33287393E-02 0.10060000E+01 0.99761817E-02 0.33265030E-02 0.33248245E-02 0.33248542E-02 0.10062000E+01 0.99645476E-02 0.33226236E-02 0.33209471E-02 0.33209769E-02 0.10064000E+01 0.99529366E-02 0.33187519E-02 0.33170774E-02 0.33171073E-02 0.10066000E+01 0.99413486E-02 0.33148879E-02 0.33132153E-02 0.33132454E-02 0.10068000E+01 0.99297835E-02 0.33110315E-02 0.33093610E-02 0.33093911E-02 0.10070000E+01 0.99182414E-02 0.33071828E-02 0.33055142E-02 0.33055444E-02 0.10072000E+01 0.99067220E-02 0.33033416E-02 0.33016751E-02 0.33017053E-02 0.10074000E+01 0.98952255E-02 0.32995081E-02 0.32978435E-02 0.32978739E-02 0.10076000E+01 0.98837516E-02 0.32956821E-02 0.32940195E-02 0.32940499E-02 0.10078000E+01 0.98723004E-02 0.32918637E-02 0.32902031E-02 0.32902336E-02 0.10080000E+01 0.98608718E-02 0.32880529E-02 0.32863942E-02 0.32864248E-02 0.10082000E+01 0.98494657E-02 0.32842495E-02 0.32825928E-02 0.32826234E-02 0.10084000E+01 0.98380821E-02 0.32804536E-02 0.32787989E-02 0.32788296E-02 0.10086000E+01 0.98267208E-02 0.32766652E-02 0.32750124E-02 0.32750432E-02 0.10088000E+01 0.98153819E-02 0.32728842E-02 0.32712334E-02 0.32712643E-02 0.10090000E+01 0.98040652E-02 0.32691107E-02 0.32674618E-02 0.32674927E-02 0.10092000E+01 0.97927708E-02 0.32653445E-02 0.32636976E-02 0.32637286E-02 0.10094000E+01 0.97814985E-02 0.32615858E-02 0.32599408E-02 0.32599719E-02 0.10096000E+01 0.97702483E-02 0.32578344E-02 0.32561914E-02 0.32562225E-02 0.10098000E+01 0.97590201E-02 0.32540903E-02 0.32524493E-02 0.32524805E-02 0.10100000E+01 0.97478139E-02 0.32503536E-02 0.32487145E-02 0.32487458E-02 0.10102000E+01 0.97366296E-02 0.32466242E-02 0.32449870E-02 0.32450184E-02 0.10104000E+01 0.97254671E-02 0.32429021E-02 0.32412668E-02 0.32412982E-02 0.10106000E+01 0.97143265E-02 0.32391872E-02 0.32375539E-02 0.32375854E-02 0.10108000E+01 0.97032075E-02 0.32354796E-02 0.32338482E-02 0.32338797E-02 0.10110000E+01 0.96921102E-02 0.32317792E-02 0.32301497E-02 0.32301813E-02 0.10112000E+01 0.96810346E-02 0.32280860E-02 0.32264584E-02 0.32264901E-02 0.10114000E+01 0.96699805E-02 0.32244000E-02 0.32227743E-02 0.32228061E-02 0.10116000E+01 0.96589479E-02 0.32207212E-02 0.32190974E-02 0.32191293E-02 0.10118000E+01 0.96479367E-02 0.32170495E-02 0.32154276E-02 0.32154595E-02 0.10120000E+01 0.96369469E-02 0.32133850E-02 0.32117649E-02 0.32117970E-02 0.10122000E+01 0.96259784E-02 0.32097275E-02 0.32081094E-02 0.32081415E-02 0.10124000E+01 0.96150311E-02 0.32060772E-02 0.32044609E-02 0.32044931E-02 0.10126000E+01 0.96041051E-02 0.32024339E-02 0.32008195E-02 0.32008517E-02 0.10128000E+01 0.95932002E-02 0.31987976E-02 0.31971852E-02 0.31972174E-02 0.10130000E+01 0.95823164E-02 0.31951684E-02 0.31935578E-02 0.31935902E-02 0.10132000E+01 0.95714537E-02 0.31915462E-02 0.31899375E-02 0.31899699E-02 0.10134000E+01 0.95606119E-02 0.31879310E-02 0.31863242E-02 0.31863567E-02 0.10136000E+01 0.95497910E-02 0.31843228E-02 0.31827178E-02 0.31827504E-02 0.10138000E+01 0.95389910E-02 0.31807215E-02 0.31791184E-02 0.31791510E-02 0.10140000E+01 0.95282118E-02 0.31771272E-02 0.31755260E-02 0.31755586E-02 0.10142000E+01 0.95174534E-02 0.31735398E-02 0.31719404E-02 0.31719732E-02 0.10144000E+01 0.95067156E-02 0.31699593E-02 0.31683617E-02 0.31683946E-02 0.10146000E+01 0.94959985E-02 0.31663857E-02 0.31647900E-02 0.31648228E-02 0.10148000E+01 0.94853019E-02 0.31628189E-02 0.31612250E-02 0.31612580E-02 0.10150000E+01 0.94746259E-02 0.31592590E-02 0.31576670E-02 0.31577000E-02 0.10152000E+01 0.94639704E-02 0.31557059E-02 0.31541157E-02 0.31541488E-02 0.10154000E+01 0.94533352E-02 0.31521596E-02 0.31505712E-02 0.31506044E-02 0.10156000E+01 0.94427205E-02 0.31486201E-02 0.31470336E-02 0.31470668E-02 0.10158000E+01 0.94321260E-02 0.31450874E-02 0.31435027E-02 0.31435359E-02 0.10160000E+01 0.94215518E-02 0.31415614E-02 0.31399785E-02 0.31400119E-02 0.10162000E+01 0.94109978E-02 0.31380422E-02 0.31364611E-02 0.31364945E-02 0.10164000E+01 0.94004639E-02 0.31345296E-02 0.31329504E-02 0.31329839E-02 0.10166000E+01 0.93899501E-02 0.31310238E-02 0.31294464E-02 0.31294799E-02 0.10168000E+01 0.93794564E-02 0.31275247E-02 0.31259491E-02 0.31259827E-02 0.10170000E+01 0.93689827E-02 0.31240322E-02 0.31224584E-02 0.31224920E-02 0.10172000E+01 0.93585288E-02 0.31205464E-02 0.31189744E-02 0.31190081E-02 0.10174000E+01 0.93480949E-02 0.31170672E-02 0.31154970E-02 0.31155307E-02 0.10176000E+01 0.93376808E-02 0.31135946E-02 0.31120262E-02 0.31120600E-02 0.10178000E+01 0.93272864E-02 0.31101286E-02 0.31085620E-02 0.31085959E-02 0.10180000E+01 0.93169118E-02 0.31066692E-02 0.31051043E-02 0.31051383E-02 0.10182000E+01 0.93065569E-02 0.31032163E-02 0.31016533E-02 0.31016873E-02 0.10184000E+01 0.92962215E-02 0.30997700E-02 0.30982087E-02 0.30982428E-02 0.10186000E+01 0.92859057E-02 0.30963302E-02 0.30947707E-02 0.30948048E-02 0.10188000E+01 0.92756095E-02 0.30928969E-02 0.30913392E-02 0.30913734E-02 0.10190000E+01 0.92653327E-02 0.30894701E-02 0.30879142E-02 0.30879484E-02 0.10192000E+01 0.92550753E-02 0.30860498E-02 0.30844956E-02 0.30845299E-02 0.10194000E+01 0.92448372E-02 0.30826359E-02 0.30810835E-02 0.30811178E-02 0.10196000E+01 0.92346185E-02 0.30792285E-02 0.30776778E-02 0.30777122E-02 0.10198000E+01 0.92244190E-02 0.30758274E-02 0.30742785E-02 0.30743130E-02 0.10200000E+01 0.92142387E-02 0.30724328E-02 0.30708857E-02 0.30709202E-02 0.10202000E+01 0.92040776E-02 0.30690446E-02 0.30674992E-02 0.30675338E-02 0.10204000E+01 0.91939356E-02 0.30656627E-02 0.30641191E-02 0.30641538E-02 0.10206000E+01 0.91838126E-02 0.30622872E-02 0.30607453E-02 0.30607801E-02 0.10208000E+01 0.91737087E-02 0.30589181E-02 0.30573779E-02 0.30574127E-02 0.10210000E+01 0.91636237E-02 0.30555552E-02 0.30540168E-02 0.30540516E-02 0.10212000E+01 0.91535576E-02 0.30521987E-02 0.30506620E-02 0.30506969E-02 0.10214000E+01 0.91435103E-02 0.30488484E-02 0.30473135E-02 0.30473484E-02 0.10216000E+01 0.91334819E-02 0.30455044E-02 0.30439712E-02 0.30440062E-02 0.10218000E+01 0.91234722E-02 0.30421667E-02 0.30406352E-02 0.30406703E-02 0.10220000E+01 0.91134812E-02 0.30388352E-02 0.30373054E-02 0.30373405E-02 0.10222000E+01 0.91035089E-02 0.30355099E-02 0.30339819E-02 0.30340170E-02 0.10224000E+01 0.90935552E-02 0.30321909E-02 0.30306645E-02 0.30306997E-02 0.10226000E+01 0.90836200E-02 0.30288780E-02 0.30273534E-02 0.30273886E-02 0.10228000E+01 0.90737034E-02 0.30255713E-02 0.30240484E-02 0.30240837E-02 0.10230000E+01 0.90638052E-02 0.30222708E-02 0.30207495E-02 0.30207849E-02 0.10232000E+01 0.90539254E-02 0.30189763E-02 0.30174568E-02 0.30174923E-02 0.10234000E+01 0.90440640E-02 0.30156881E-02 0.30141702E-02 0.30142057E-02 0.10236000E+01 0.90342210E-02 0.30124059E-02 0.30108898E-02 0.30109253E-02 0.10238000E+01 0.90243962E-02 0.30091298E-02 0.30076154E-02 0.30076510E-02 0.10240000E+01 0.90145896E-02 0.30058598E-02 0.30043471E-02 0.30043827E-02 0.10242000E+01 0.90048012E-02 0.30025959E-02 0.30010848E-02 0.30011205E-02 0.10244000E+01 0.89950309E-02 0.29993380E-02 0.29978286E-02 0.29978643E-02 0.10246000E+01 0.89852787E-02 0.29960861E-02 0.29945784E-02 0.29946142E-02 0.10248000E+01 0.89755446E-02 0.29928403E-02 0.29913342E-02 0.29913701E-02 0.10250000E+01 0.89658284E-02 0.29896004E-02 0.29880961E-02 0.29881320E-02 0.10252000E+01 0.89561302E-02 0.29863665E-02 0.29848639E-02 0.29848998E-02 0.10254000E+01 0.89464499E-02 0.29831386E-02 0.29816376E-02 0.29816736E-02 0.10256000E+01 0.89367874E-02 0.29799167E-02 0.29784173E-02 0.29784534E-02 0.10258000E+01 0.89271428E-02 0.29767007E-02 0.29752030E-02 0.29752391E-02 0.10260000E+01 0.89175159E-02 0.29734906E-02 0.29719946E-02 0.29720307E-02 0.10262000E+01 0.89079067E-02 0.29702864E-02 0.29687920E-02 0.29688282E-02 0.10264000E+01 0.88983152E-02 0.29670881E-02 0.29655954E-02 0.29656316E-02 0.10266000E+01 0.88887413E-02 0.29638957E-02 0.29624046E-02 0.29624409E-02 0.10268000E+01 0.88791849E-02 0.29607091E-02 0.29592197E-02 0.29592561E-02 0.10270000E+01 0.88696462E-02 0.29575284E-02 0.29560407E-02 0.29560770E-02 0.10272000E+01 0.88601249E-02 0.29543536E-02 0.29528674E-02 0.29529039E-02 0.10274000E+01 0.88506210E-02 0.29511845E-02 0.29497000E-02 0.29497365E-02 0.10276000E+01 0.88411345E-02 0.29480212E-02 0.29465384E-02 0.29465749E-02 0.10278000E+01 0.88316654E-02 0.29448638E-02 0.29433825E-02 0.29434191E-02 0.10280000E+01 0.88222136E-02 0.29417121E-02 0.29402325E-02 0.29402691E-02 0.10282000E+01 0.88127791E-02 0.29385661E-02 0.29370881E-02 0.29371248E-02 0.10284000E+01 0.88033618E-02 0.29354259E-02 0.29339496E-02 0.29339863E-02 0.10286000E+01 0.87939616E-02 0.29322915E-02 0.29308167E-02 0.29308535E-02 0.10288000E+01 0.87845786E-02 0.29291627E-02 0.29276896E-02 0.29277264E-02 0.10290000E+01 0.87752127E-02 0.29260396E-02 0.29245681E-02 0.29246050E-02 0.10292000E+01 0.87658639E-02 0.29229223E-02 0.29214523E-02 0.29214893E-02 0.10294000E+01 0.87565320E-02 0.29198106E-02 0.29183422E-02 0.29183792E-02 0.10296000E+01 0.87472171E-02 0.29167045E-02 0.29152378E-02 0.29152748E-02 0.10298000E+01 0.87379191E-02 0.29136041E-02 0.29121390E-02 0.29121760E-02 0.10300000E+01 0.87286380E-02 0.29105093E-02 0.29090458E-02 0.29090829E-02 0.10302000E+01 0.87193737E-02 0.29074201E-02 0.29059582E-02 0.29059953E-02 0.10304000E+01 0.87101262E-02 0.29043365E-02 0.29028762E-02 0.29029134E-02 0.10306000E+01 0.87008954E-02 0.29012586E-02 0.28997998E-02 0.28998370E-02 0.10308000E+01 0.86916814E-02 0.28981861E-02 0.28967290E-02 0.28967662E-02 0.10310000E+01 0.86824840E-02 0.28951193E-02 0.28936637E-02 0.28937010E-02 0.10312000E+01 0.86733032E-02 0.28920579E-02 0.28906040E-02 0.28906413E-02 0.10314000E+01 0.86641390E-02 0.28890021E-02 0.28875497E-02 0.28875871E-02 0.10316000E+01 0.86549913E-02 0.28859518E-02 0.28845010E-02 0.28845385E-02 0.10318000E+01 0.86458601E-02 0.28829071E-02 0.28814578E-02 0.28814953E-02 0.10320000E+01 0.86367454E-02 0.28798678E-02 0.28784201E-02 0.28784576E-02 0.10322000E+01 0.86276471E-02 0.28768339E-02 0.28753878E-02 0.28754254E-02 0.10324000E+01 0.86185651E-02 0.28738056E-02 0.28723610E-02 0.28723986E-02 0.10326000E+01 0.86094995E-02 0.28707826E-02 0.28693396E-02 0.28693773E-02 0.10328000E+01 0.86004502E-02 0.28677651E-02 0.28663237E-02 0.28663614E-02 0.10330000E+01 0.85914171E-02 0.28647531E-02 0.28633132E-02 0.28633509E-02 0.10332000E+01 0.85824002E-02 0.28617464E-02 0.28603080E-02 0.28603458E-02 0.10334000E+01 0.85733995E-02 0.28587451E-02 0.28573083E-02 0.28573461E-02 0.10336000E+01 0.85644149E-02 0.28557492E-02 0.28543139E-02 0.28543518E-02 0.10338000E+01 0.85554464E-02 0.28527586E-02 0.28513249E-02 0.28513628E-02 0.10340000E+01 0.85464939E-02 0.28497734E-02 0.28483413E-02 0.28483792E-02 0.10342000E+01 0.85375574E-02 0.28467936E-02 0.28453629E-02 0.28454009E-02 0.10344000E+01 0.85286369E-02 0.28438190E-02 0.28423899E-02 0.28424280E-02 0.10346000E+01 0.85197323E-02 0.28408498E-02 0.28394222E-02 0.28394603E-02 0.10348000E+01 0.85108436E-02 0.28378859E-02 0.28364598E-02 0.28364979E-02 0.10350000E+01 0.85019708E-02 0.28349272E-02 0.28335027E-02 0.28335408E-02 0.10352000E+01 0.84931137E-02 0.28319738E-02 0.28305508E-02 0.28305890E-02 0.10354000E+01 0.84842724E-02 0.28290257E-02 0.28276042E-02 0.28276425E-02 0.10356000E+01 0.84754468E-02 0.28260828E-02 0.28246629E-02 0.28247011E-02 0.10358000E+01 0.84666369E-02 0.28231452E-02 0.28217267E-02 0.28217650E-02 0.10360000E+01 0.84578427E-02 0.28202127E-02 0.28187958E-02 0.28188342E-02 0.10362000E+01 0.84490641E-02 0.28172855E-02 0.28158701E-02 0.28159085E-02 0.10364000E+01 0.84403010E-02 0.28143635E-02 0.28129496E-02 0.28129880E-02 0.10366000E+01 0.84315535E-02 0.28114466E-02 0.28100342E-02 0.28100727E-02 0.10368000E+01 0.84228214E-02 0.28085349E-02 0.28071240E-02 0.28071625E-02 0.10370000E+01 0.84141049E-02 0.28056284E-02 0.28042190E-02 0.28042575E-02 0.10372000E+01 0.84054037E-02 0.28027270E-02 0.28013191E-02 0.28013576E-02 0.10374000E+01 0.83967179E-02 0.27998307E-02 0.27984243E-02 0.27984629E-02 0.10376000E+01 0.83880474E-02 0.27969395E-02 0.27955346E-02 0.27955733E-02 0.10378000E+01 0.83793923E-02 0.27940535E-02 0.27926501E-02 0.27926887E-02 0.10380000E+01 0.83707524E-02 0.27911725E-02 0.27897706E-02 0.27898093E-02 0.10382000E+01 0.83621277E-02 0.27882966E-02 0.27868962E-02 0.27869349E-02 0.10384000E+01 0.83535183E-02 0.27854258E-02 0.27840268E-02 0.27840656E-02 0.10386000E+01 0.83449239E-02 0.27825600E-02 0.27811625E-02 0.27812014E-02 0.10388000E+01 0.83363447E-02 0.27796993E-02 0.27783033E-02 0.27783421E-02 0.10390000E+01 0.83277806E-02 0.27768436E-02 0.27754490E-02 0.27754879E-02 0.10392000E+01 0.83192315E-02 0.27739929E-02 0.27725998E-02 0.27726388E-02 0.10394000E+01 0.83106974E-02 0.27711472E-02 0.27697556E-02 0.27697946E-02 0.10396000E+01 0.83021783E-02 0.27683065E-02 0.27669164E-02 0.27669554E-02 0.10398000E+01 0.82936741E-02 0.27654708E-02 0.27640821E-02 0.27641212E-02 0.10400000E+01 0.82851848E-02 0.27626401E-02 0.27612528E-02 0.27612919E-02 0.10402000E+01 0.82767103E-02 0.27598143E-02 0.27584285E-02 0.27584676E-02 0.10404000E+01 0.82682507E-02 0.27569934E-02 0.27556091E-02 0.27556482E-02 0.10406000E+01 0.82598059E-02 0.27541775E-02 0.27527946E-02 0.27528338E-02 0.10408000E+01 0.82513758E-02 0.27513665E-02 0.27499850E-02 0.27500243E-02 0.10410000E+01 0.82429604E-02 0.27485604E-02 0.27471804E-02 0.27472196E-02 0.10412000E+01 0.82345597E-02 0.27457591E-02 0.27443806E-02 0.27444199E-02 0.10414000E+01 0.82261736E-02 0.27429628E-02 0.27415857E-02 0.27416250E-02 0.10416000E+01 0.82178021E-02 0.27401714E-02 0.27387957E-02 0.27388350E-02 0.10418000E+01 0.82094452E-02 0.27373848E-02 0.27360105E-02 0.27360499E-02 0.10420000E+01 0.82011028E-02 0.27346030E-02 0.27332302E-02 0.27332696E-02 0.10422000E+01 0.81927750E-02 0.27318261E-02 0.27304547E-02 0.27304942E-02 0.10424000E+01 0.81844616E-02 0.27290540E-02 0.27276841E-02 0.27277235E-02 0.10426000E+01 0.81761626E-02 0.27262867E-02 0.27249182E-02 0.27249577E-02 0.10428000E+01 0.81678780E-02 0.27235242E-02 0.27221571E-02 0.27221967E-02 0.10430000E+01 0.81596078E-02 0.27207665E-02 0.27194008E-02 0.27194404E-02 0.10432000E+01 0.81513518E-02 0.27180136E-02 0.27166493E-02 0.27166889E-02 0.10434000E+01 0.81431102E-02 0.27152654E-02 0.27139026E-02 0.27139422E-02 0.10436000E+01 0.81348829E-02 0.27125220E-02 0.27111606E-02 0.27112003E-02 0.10438000E+01 0.81266697E-02 0.27097833E-02 0.27084233E-02 0.27084630E-02 0.10440000E+01 0.81184707E-02 0.27070494E-02 0.27056908E-02 0.27057305E-02 0.10442000E+01 0.81102859E-02 0.27043202E-02 0.27029630E-02 0.27030028E-02 0.10444000E+01 0.81021152E-02 0.27015957E-02 0.27002399E-02 0.27002797E-02 0.10446000E+01 0.80939586E-02 0.26988758E-02 0.26975215E-02 0.26975613E-02 0.10448000E+01 0.80858160E-02 0.26961607E-02 0.26948077E-02 0.26948476E-02 0.10450000E+01 0.80776875E-02 0.26934502E-02 0.26920987E-02 0.26921386E-02 0.10452000E+01 0.80695729E-02 0.26907444E-02 0.26893943E-02 0.26894342E-02 0.10454000E+01 0.80614723E-02 0.26880433E-02 0.26866945E-02 0.26867345E-02 0.10456000E+01 0.80533855E-02 0.26853468E-02 0.26839994E-02 0.26840394E-02 0.10458000E+01 0.80453127E-02 0.26826549E-02 0.26813089E-02 0.26813489E-02 0.10460000E+01 0.80372537E-02 0.26799676E-02 0.26786230E-02 0.26786631E-02 0.10462000E+01 0.80292085E-02 0.26772850E-02 0.26759417E-02 0.26759818E-02 0.10464000E+01 0.80211771E-02 0.26746069E-02 0.26732651E-02 0.26733052E-02 0.10466000E+01 0.80131595E-02 0.26719334E-02 0.26705930E-02 0.26706331E-02 0.10468000E+01 0.80051555E-02 0.26692645E-02 0.26679254E-02 0.26679656E-02 0.10470000E+01 0.79971653E-02 0.26666002E-02 0.26652625E-02 0.26653026E-02 0.10472000E+01 0.79891887E-02 0.26639404E-02 0.26626040E-02 0.26626442E-02 0.10474000E+01 0.79812257E-02 0.26612852E-02 0.26599501E-02 0.26599904E-02 0.10476000E+01 0.79732763E-02 0.26586344E-02 0.26573008E-02 0.26573411E-02 0.10478000E+01 0.79653404E-02 0.26559882E-02 0.26546559E-02 0.26546962E-02 0.10480000E+01 0.79574181E-02 0.26533465E-02 0.26520156E-02 0.26520559E-02 0.10482000E+01 0.79495092E-02 0.26507093E-02 0.26493798E-02 0.26494201E-02 0.10484000E+01 0.79416138E-02 0.26480766E-02 0.26467484E-02 0.26467888E-02 0.10486000E+01 0.79337319E-02 0.26454484E-02 0.26441215E-02 0.26441619E-02 0.10488000E+01 0.79258633E-02 0.26428246E-02 0.26414991E-02 0.26415395E-02 0.10490000E+01 0.79180080E-02 0.26402053E-02 0.26388811E-02 0.26389216E-02 0.10492000E+01 0.79101661E-02 0.26375904E-02 0.26362676E-02 0.26363081E-02 0.10494000E+01 0.79023375E-02 0.26349800E-02 0.26336585E-02 0.26336990E-02 0.10496000E+01 0.78945222E-02 0.26323740E-02 0.26310538E-02 0.26310944E-02 0.10498000E+01 0.78867201E-02 0.26297724E-02 0.26284536E-02 0.26284941E-02 0.10500000E+01 0.78789312E-02 0.26271752E-02 0.26258577E-02 0.26258983E-02 0.10502000E+01 0.78711554E-02 0.26245823E-02 0.26232662E-02 0.26233069E-02 0.10504000E+01 0.78633928E-02 0.26219939E-02 0.26206791E-02 0.26207198E-02 0.10506000E+01 0.78556433E-02 0.26194099E-02 0.26180964E-02 0.26181371E-02 0.10508000E+01 0.78479069E-02 0.26168302E-02 0.26155180E-02 0.26155587E-02 0.10510000E+01 0.78401836E-02 0.26142548E-02 0.26129440E-02 0.26129847E-02 0.10512000E+01 0.78324732E-02 0.26116838E-02 0.26103743E-02 0.26104151E-02 0.10514000E+01 0.78247758E-02 0.26091171E-02 0.26078090E-02 0.26078497E-02 0.10516000E+01 0.78170914E-02 0.26065548E-02 0.26052479E-02 0.26052887E-02 0.10518000E+01 0.78094199E-02 0.26039967E-02 0.26026912E-02 0.26027320E-02 0.10520000E+01 0.78017613E-02 0.26014430E-02 0.26001388E-02 0.26001796E-02 0.10522000E+01 0.77941156E-02 0.25988935E-02 0.25975906E-02 0.25976315E-02 0.10524000E+01 0.77864827E-02 0.25963483E-02 0.25950467E-02 0.25950876E-02 0.10526000E+01 0.77788626E-02 0.25938074E-02 0.25925071E-02 0.25925481E-02 0.10528000E+01 0.77712552E-02 0.25912707E-02 0.25899718E-02 0.25900127E-02 0.10530000E+01 0.77636606E-02 0.25887383E-02 0.25874407E-02 0.25874816E-02 0.10532000E+01 0.77560788E-02 0.25862102E-02 0.25849138E-02 0.25849548E-02 0.10534000E+01 0.77485096E-02 0.25836862E-02 0.25823912E-02 0.25824322E-02 0.10536000E+01 0.77409530E-02 0.25811665E-02 0.25798727E-02 0.25799138E-02 0.10538000E+01 0.77334091E-02 0.25786510E-02 0.25773585E-02 0.25773996E-02 0.10540000E+01 0.77258778E-02 0.25761397E-02 0.25748485E-02 0.25748896E-02 0.10542000E+01 0.77183590E-02 0.25736326E-02 0.25723427E-02 0.25723838E-02 0.10544000E+01 0.77108528E-02 0.25711296E-02 0.25698410E-02 0.25698822E-02 0.10546000E+01 0.77033591E-02 0.25686308E-02 0.25673435E-02 0.25673847E-02 0.10548000E+01 0.76958778E-02 0.25661362E-02 0.25648502E-02 0.25648914E-02 0.10550000E+01 0.76884090E-02 0.25636458E-02 0.25623610E-02 0.25624022E-02 0.10552000E+01 0.76809526E-02 0.25611594E-02 0.25598760E-02 0.25599172E-02 0.10554000E+01 0.76735087E-02 0.25586773E-02 0.25573951E-02 0.25574363E-02 0.10556000E+01 0.76660770E-02 0.25561992E-02 0.25549183E-02 0.25549596E-02 0.10558000E+01 0.76586577E-02 0.25537252E-02 0.25524456E-02 0.25524869E-02 0.10560000E+01 0.76512507E-02 0.25512554E-02 0.25499770E-02 0.25500183E-02 0.10562000E+01 0.76438560E-02 0.25487896E-02 0.25475125E-02 0.25475539E-02 0.10564000E+01 0.76364735E-02 0.25463279E-02 0.25450521E-02 0.25450935E-02 0.10566000E+01 0.76291033E-02 0.25438703E-02 0.25425958E-02 0.25426372E-02 0.10568000E+01 0.76217452E-02 0.25414168E-02 0.25401435E-02 0.25401849E-02 0.10570000E+01 0.76143993E-02 0.25389673E-02 0.25376953E-02 0.25377367E-02 0.10572000E+01 0.76070656E-02 0.25365219E-02 0.25352511E-02 0.25352926E-02 0.10574000E+01 0.75997439E-02 0.25340805E-02 0.25328110E-02 0.25328524E-02 0.10576000E+01 0.75924343E-02 0.25316431E-02 0.25303748E-02 0.25304163E-02 0.10578000E+01 0.75851368E-02 0.25292098E-02 0.25279427E-02 0.25279843E-02 0.10580000E+01 0.75778513E-02 0.25267804E-02 0.25255146E-02 0.25255562E-02 0.10582000E+01 0.75705777E-02 0.25243551E-02 0.25230905E-02 0.25231321E-02 0.10584000E+01 0.75633162E-02 0.25219337E-02 0.25206704E-02 0.25207120E-02 0.10586000E+01 0.75560666E-02 0.25195164E-02 0.25182543E-02 0.25182959E-02 0.10588000E+01 0.75488289E-02 0.25171030E-02 0.25158421E-02 0.25158838E-02 0.10590000E+01 0.75416031E-02 0.25146935E-02 0.25134339E-02 0.25134756E-02 0.10592000E+01 0.75343891E-02 0.25122880E-02 0.25110297E-02 0.25110714E-02 0.10594000E+01 0.75271870E-02 0.25098865E-02 0.25086294E-02 0.25086711E-02 0.10596000E+01 0.75199966E-02 0.25074889E-02 0.25062330E-02 0.25062747E-02 0.10598000E+01 0.75128181E-02 0.25050952E-02 0.25038406E-02 0.25038823E-02 0.10600000E+01 0.75056513E-02 0.25027054E-02 0.25014520E-02 0.25014938E-02 0.10602000E+01 0.74984962E-02 0.25003196E-02 0.24990674E-02 0.24991092E-02 0.10604000E+01 0.74913528E-02 0.24979376E-02 0.24966867E-02 0.24967285E-02 0.10606000E+01 0.74842211E-02 0.24955596E-02 0.24943098E-02 0.24943517E-02 0.10608000E+01 0.74771010E-02 0.24931854E-02 0.24919369E-02 0.24919787E-02 0.10610000E+01 0.74699925E-02 0.24908151E-02 0.24895678E-02 0.24896097E-02 0.10612000E+01 0.74628957E-02 0.24884487E-02 0.24872026E-02 0.24872444E-02 0.10614000E+01 0.74558104E-02 0.24860861E-02 0.24848412E-02 0.24848831E-02 0.10616000E+01 0.74487366E-02 0.24837273E-02 0.24824837E-02 0.24825256E-02 0.10618000E+01 0.74416743E-02 0.24813724E-02 0.24801300E-02 0.24801719E-02 0.10620000E+01 0.74346235E-02 0.24790213E-02 0.24777801E-02 0.24778221E-02 0.10622000E+01 0.74275842E-02 0.24766741E-02 0.24754341E-02 0.24754760E-02 0.10624000E+01 0.74205563E-02 0.24743306E-02 0.24730918E-02 0.24731338E-02 0.10626000E+01 0.74135398E-02 0.24719910E-02 0.24707534E-02 0.24707954E-02 0.10628000E+01 0.74065347E-02 0.24696552E-02 0.24684188E-02 0.24684608E-02 0.10630000E+01 0.73995409E-02 0.24673231E-02 0.24660879E-02 0.24661299E-02 0.10632000E+01 0.73925585E-02 0.24649948E-02 0.24637608E-02 0.24638029E-02 0.10634000E+01 0.73855874E-02 0.24626703E-02 0.24614375E-02 0.24614796E-02 0.10636000E+01 0.73786275E-02 0.24603496E-02 0.24591179E-02 0.24591600E-02 0.10638000E+01 0.73716789E-02 0.24580326E-02 0.24568021E-02 0.24568442E-02 0.10640000E+01 0.73647415E-02 0.24557193E-02 0.24544900E-02 0.24545322E-02 0.10642000E+01 0.73578153E-02 0.24534098E-02 0.24521817E-02 0.24522238E-02 0.10644000E+01 0.73509003E-02 0.24511040E-02 0.24498771E-02 0.24499193E-02 0.10646000E+01 0.73439965E-02 0.24488019E-02 0.24475762E-02 0.24476184E-02 0.10648000E+01 0.73371037E-02 0.24465035E-02 0.24452790E-02 0.24453212E-02 0.10650000E+01 0.73302221E-02 0.24442089E-02 0.24429855E-02 0.24430277E-02 0.10652000E+01 0.73233515E-02 0.24419179E-02 0.24406957E-02 0.24407379E-02 0.10654000E+01 0.73164920E-02 0.24396306E-02 0.24384096E-02 0.24384518E-02 0.10656000E+01 0.73096435E-02 0.24373470E-02 0.24361272E-02 0.24361694E-02 0.10658000E+01 0.73028061E-02 0.24350670E-02 0.24338484E-02 0.24338907E-02 0.10660000E+01 0.72959795E-02 0.24327907E-02 0.24315733E-02 0.24316156E-02 0.10662000E+01 0.72891640E-02 0.24305181E-02 0.24293018E-02 0.24293441E-02 0.10664000E+01 0.72823593E-02 0.24282491E-02 0.24270340E-02 0.24270763E-02 0.10666000E+01 0.72755656E-02 0.24259837E-02 0.24247698E-02 0.24248121E-02 0.10668000E+01 0.72687827E-02 0.24237220E-02 0.24225092E-02 0.24225516E-02 0.10670000E+01 0.72620107E-02 0.24214639E-02 0.24202522E-02 0.24202946E-02 0.10672000E+01 0.72552496E-02 0.24192094E-02 0.24179989E-02 0.24180413E-02 0.10674000E+01 0.72484992E-02 0.24169585E-02 0.24157491E-02 0.24157916E-02 0.10676000E+01 0.72417596E-02 0.24147112E-02 0.24135030E-02 0.24135454E-02 0.10678000E+01 0.72350307E-02 0.24124675E-02 0.24112604E-02 0.24113029E-02 0.10680000E+01 0.72283126E-02 0.24102273E-02 0.24090214E-02 0.24090639E-02 0.10682000E+01 0.72216052E-02 0.24079907E-02 0.24067860E-02 0.24068285E-02 0.10684000E+01 0.72149085E-02 0.24057577E-02 0.24045542E-02 0.24045966E-02 0.10686000E+01 0.72082225E-02 0.24035283E-02 0.24023258E-02 0.24023683E-02 0.10688000E+01 0.72015470E-02 0.24013024E-02 0.24001011E-02 0.24001436E-02 0.10690000E+01 0.71948822E-02 0.23990800E-02 0.23978799E-02 0.23979224E-02 0.10692000E+01 0.71882280E-02 0.23968612E-02 0.23956622E-02 0.23957047E-02 0.10694000E+01 0.71815844E-02 0.23946459E-02 0.23934480E-02 0.23934905E-02 0.10696000E+01 0.71749512E-02 0.23924341E-02 0.23912373E-02 0.23912799E-02 0.10698000E+01 0.71683286E-02 0.23902258E-02 0.23890302E-02 0.23890727E-02 0.10700000E+01 0.71617165E-02 0.23880210E-02 0.23868265E-02 0.23868691E-02 0.10702000E+01 0.71551149E-02 0.23858197E-02 0.23846263E-02 0.23846689E-02 0.10704000E+01 0.71485237E-02 0.23836218E-02 0.23824296E-02 0.23824723E-02 0.10706000E+01 0.71419430E-02 0.23814275E-02 0.23802364E-02 0.23802791E-02 0.10708000E+01 0.71353726E-02 0.23792366E-02 0.23780467E-02 0.23780893E-02 0.10710000E+01 0.71288127E-02 0.23770492E-02 0.23758604E-02 0.23759031E-02 0.10712000E+01 0.71222630E-02 0.23748653E-02 0.23736775E-02 0.23737202E-02 0.10714000E+01 0.71157238E-02 0.23726848E-02 0.23714982E-02 0.23715408E-02 0.10716000E+01 0.71091948E-02 0.23705077E-02 0.23693222E-02 0.23693649E-02 0.10718000E+01 0.71026761E-02 0.23683340E-02 0.23671497E-02 0.23671924E-02 0.10720000E+01 0.70961677E-02 0.23661638E-02 0.23649806E-02 0.23650233E-02 0.10722000E+01 0.70896695E-02 0.23639970E-02 0.23628149E-02 0.23628576E-02 0.10724000E+01 0.70831815E-02 0.23618336E-02 0.23606526E-02 0.23606953E-02 0.10726000E+01 0.70767038E-02 0.23596736E-02 0.23584937E-02 0.23585365E-02 0.10728000E+01 0.70702362E-02 0.23575170E-02 0.23563382E-02 0.23563810E-02 0.10730000E+01 0.70637788E-02 0.23553638E-02 0.23541861E-02 0.23542289E-02 0.10732000E+01 0.70573315E-02 0.23532140E-02 0.23520374E-02 0.23520802E-02 0.10734000E+01 0.70508943E-02 0.23510675E-02 0.23498920E-02 0.23499348E-02 0.10736000E+01 0.70444672E-02 0.23489244E-02 0.23477500E-02 0.23477928E-02 0.10738000E+01 0.70380501E-02 0.23467846E-02 0.23456113E-02 0.23456542E-02 0.10740000E+01 0.70316431E-02 0.23446482E-02 0.23434760E-02 0.23435189E-02 0.10742000E+01 0.70252462E-02 0.23425152E-02 0.23413441E-02 0.23413869E-02 0.10744000E+01 0.70188592E-02 0.23403854E-02 0.23392154E-02 0.23392583E-02 0.10746000E+01 0.70124822E-02 0.23382590E-02 0.23370901E-02 0.23371330E-02 0.10748000E+01 0.70061151E-02 0.23361360E-02 0.23349681E-02 0.23350110E-02 0.10750000E+01 0.69997580E-02 0.23340162E-02 0.23328494E-02 0.23328924E-02 0.10752000E+01 0.69934108E-02 0.23318997E-02 0.23307341E-02 0.23307770E-02 0.10754000E+01 0.69870735E-02 0.23297866E-02 0.23286220E-02 0.23286649E-02 0.10756000E+01 0.69807460E-02 0.23276767E-02 0.23265132E-02 0.23265561E-02 0.10758000E+01 0.69744284E-02 0.23255701E-02 0.23244077E-02 0.23244506E-02 0.10760000E+01 0.69681206E-02 0.23234668E-02 0.23223054E-02 0.23223484E-02 0.10762000E+01 0.69618226E-02 0.23213667E-02 0.23202065E-02 0.23202495E-02 0.10764000E+01 0.69555345E-02 0.23192699E-02 0.23181108E-02 0.23181538E-02 0.10766000E+01 0.69492560E-02 0.23171764E-02 0.23160183E-02 0.23160613E-02 0.10768000E+01 0.69429873E-02 0.23150861E-02 0.23139291E-02 0.23139721E-02 0.10770000E+01 0.69367283E-02 0.23129991E-02 0.23118431E-02 0.23118862E-02 0.10772000E+01 0.69304791E-02 0.23109153E-02 0.23097604E-02 0.23098034E-02 0.10774000E+01 0.69242395E-02 0.23088347E-02 0.23076809E-02 0.23077239E-02 0.10776000E+01 0.69180095E-02 0.23067573E-02 0.23056046E-02 0.23056476E-02 0.10778000E+01 0.69117892E-02 0.23046832E-02 0.23035315E-02 0.23035746E-02 0.10780000E+01 0.69055785E-02 0.23026122E-02 0.23014616E-02 0.23015047E-02 0.10782000E+01 0.68993774E-02 0.23005445E-02 0.22993949E-02 0.22994380E-02 0.10784000E+01 0.68931859E-02 0.22984799E-02 0.22973314E-02 0.22973745E-02 0.10786000E+01 0.68870039E-02 0.22964186E-02 0.22952711E-02 0.22953142E-02 0.10788000E+01 0.68808314E-02 0.22943604E-02 0.22932140E-02 0.22932571E-02 0.10790000E+01 0.68746685E-02 0.22923053E-02 0.22911600E-02 0.22912031E-02 0.10792000E+01 0.68685150E-02 0.22902535E-02 0.22891092E-02 0.22891523E-02 0.10794000E+01 0.68623711E-02 0.22882048E-02 0.22870615E-02 0.22871047E-02 0.10796000E+01 0.68562365E-02 0.22861592E-02 0.22850170E-02 0.22850602E-02 0.10798000E+01 0.68501114E-02 0.22841168E-02 0.22829757E-02 0.22830189E-02 0.10800000E+01 0.68439957E-02 0.22820776E-02 0.22809375E-02 0.22809807E-02 0.10802000E+01 0.68378894E-02 0.22800414E-02 0.22789024E-02 0.22789456E-02 0.10804000E+01 0.68317925E-02 0.22780084E-02 0.22768704E-02 0.22769136E-02 0.10806000E+01 0.68257049E-02 0.22759785E-02 0.22748416E-02 0.22748848E-02 0.10808000E+01 0.68196266E-02 0.22739518E-02 0.22728158E-02 0.22728590E-02 0.10810000E+01 0.68135576E-02 0.22719281E-02 0.22707932E-02 0.22708364E-02 0.10812000E+01 0.68074980E-02 0.22699075E-02 0.22687736E-02 0.22688169E-02 0.10814000E+01 0.68014476E-02 0.22678900E-02 0.22667572E-02 0.22668004E-02 0.10816000E+01 0.67954064E-02 0.22658756E-02 0.22647438E-02 0.22647870E-02 0.10818000E+01 0.67893745E-02 0.22638642E-02 0.22627335E-02 0.22627768E-02 0.10820000E+01 0.67833518E-02 0.22618560E-02 0.22607263E-02 0.22607695E-02 0.10822000E+01 0.67773382E-02 0.22598508E-02 0.22587221E-02 0.22587654E-02 0.10824000E+01 0.67713339E-02 0.22578486E-02 0.22567210E-02 0.22567643E-02 0.10826000E+01 0.67653387E-02 0.22558496E-02 0.22547229E-02 0.22547662E-02 0.10828000E+01 0.67593526E-02 0.22538535E-02 0.22527279E-02 0.22527712E-02 0.10830000E+01 0.67533756E-02 0.22518605E-02 0.22507359E-02 0.22507792E-02 0.10832000E+01 0.67474077E-02 0.22498705E-02 0.22487469E-02 0.22487903E-02 0.10834000E+01 0.67414489E-02 0.22478836E-02 0.22467610E-02 0.22468043E-02 0.10836000E+01 0.67354992E-02 0.22458996E-02 0.22447781E-02 0.22448214E-02 0.10838000E+01 0.67295585E-02 0.22439187E-02 0.22427982E-02 0.22428415E-02 0.10840000E+01 0.67236267E-02 0.22419408E-02 0.22408213E-02 0.22408647E-02 0.10842000E+01 0.67177040E-02 0.22399659E-02 0.22388474E-02 0.22388908E-02 0.10844000E+01 0.67117903E-02 0.22379940E-02 0.22368765E-02 0.22369199E-02 0.10846000E+01 0.67058855E-02 0.22360250E-02 0.22349085E-02 0.22349519E-02 0.10848000E+01 0.66999897E-02 0.22340591E-02 0.22329436E-02 0.22329870E-02 0.10850000E+01 0.66941028E-02 0.22320961E-02 0.22309816E-02 0.22310250E-02 0.10852000E+01 0.66882247E-02 0.22301361E-02 0.22290226E-02 0.22290660E-02 0.10854000E+01 0.66823556E-02 0.22281790E-02 0.22270666E-02 0.22271100E-02 0.10856000E+01 0.66764953E-02 0.22262249E-02 0.22251135E-02 0.22251569E-02 0.10858000E+01 0.66706439E-02 0.22242738E-02 0.22231633E-02 0.22232068E-02 0.10860000E+01 0.66648013E-02 0.22223256E-02 0.22212161E-02 0.22212596E-02 0.10862000E+01 0.66589675E-02 0.22203803E-02 0.22192718E-02 0.22193153E-02 0.10864000E+01 0.66531425E-02 0.22184380E-02 0.22173305E-02 0.22173740E-02 0.10866000E+01 0.66473262E-02 0.22164986E-02 0.22153921E-02 0.22154355E-02 0.10868000E+01 0.66415187E-02 0.22145621E-02 0.22134566E-02 0.22135001E-02 0.10870000E+01 0.66357199E-02 0.22126285E-02 0.22115240E-02 0.22115675E-02 0.10872000E+01 0.66299299E-02 0.22106978E-02 0.22095943E-02 0.22096378E-02 0.10874000E+01 0.66241485E-02 0.22087700E-02 0.22076675E-02 0.22077110E-02 0.10876000E+01 0.66183759E-02 0.22068451E-02 0.22057436E-02 0.22057871E-02 0.10878000E+01 0.66126119E-02 0.22049232E-02 0.22038226E-02 0.22038661E-02 0.10880000E+01 0.66068565E-02 0.22030040E-02 0.22019045E-02 0.22019480E-02 0.10882000E+01 0.66011097E-02 0.22010878E-02 0.21999892E-02 0.22000327E-02 0.10884000E+01 0.65953716E-02 0.21991744E-02 0.21980768E-02 0.21981203E-02 0.10886000E+01 0.65896420E-02 0.21972639E-02 0.21961673E-02 0.21962108E-02 0.10888000E+01 0.65839210E-02 0.21953563E-02 0.21942606E-02 0.21943041E-02 0.10890000E+01 0.65782086E-02 0.21934515E-02 0.21923568E-02 0.21924003E-02 0.10892000E+01 0.65725047E-02 0.21915495E-02 0.21904558E-02 0.21904994E-02 0.10894000E+01 0.65668093E-02 0.21896504E-02 0.21885577E-02 0.21886012E-02 0.10896000E+01 0.65611224E-02 0.21877541E-02 0.21866624E-02 0.21867059E-02 0.10898000E+01 0.65554440E-02 0.21858607E-02 0.21847699E-02 0.21848134E-02 0.10900000E+01 0.65497740E-02 0.21839700E-02 0.21828802E-02 0.21829238E-02 0.10902000E+01 0.65441125E-02 0.21820822E-02 0.21809934E-02 0.21810369E-02 0.10904000E+01 0.65384594E-02 0.21801972E-02 0.21791093E-02 0.21791529E-02 0.10906000E+01 0.65328147E-02 0.21783150E-02 0.21772281E-02 0.21772717E-02 0.10908000E+01 0.65271784E-02 0.21764356E-02 0.21753496E-02 0.21753932E-02 0.10910000E+01 0.65215505E-02 0.21745590E-02 0.21734740E-02 0.21735176E-02 0.10912000E+01 0.65159310E-02 0.21726852E-02 0.21716011E-02 0.21716447E-02 0.10914000E+01 0.65103198E-02 0.21708141E-02 0.21697310E-02 0.21697746E-02 0.10916000E+01 0.65047169E-02 0.21689458E-02 0.21678637E-02 0.21679073E-02 0.10918000E+01 0.64991223E-02 0.21670803E-02 0.21659992E-02 0.21660428E-02 0.10920000E+01 0.64935360E-02 0.21652176E-02 0.21641374E-02 0.21641810E-02 0.10922000E+01 0.64879580E-02 0.21633576E-02 0.21622784E-02 0.21623220E-02 0.10924000E+01 0.64823882E-02 0.21615004E-02 0.21604221E-02 0.21604657E-02 0.10926000E+01 0.64768266E-02 0.21596459E-02 0.21585685E-02 0.21586122E-02 0.10928000E+01 0.64712733E-02 0.21577942E-02 0.21567178E-02 0.21567614E-02 0.10930000E+01 0.64657282E-02 0.21559452E-02 0.21548697E-02 0.21549133E-02 0.10932000E+01 0.64601913E-02 0.21540989E-02 0.21530244E-02 0.21530680E-02 0.10934000E+01 0.64546625E-02 0.21522553E-02 0.21511818E-02 0.21512254E-02 0.10936000E+01 0.64491419E-02 0.21504145E-02 0.21493419E-02 0.21493855E-02 0.10938000E+01 0.64436294E-02 0.21485764E-02 0.21475047E-02 0.21475483E-02 0.10940000E+01 0.64381250E-02 0.21467410E-02 0.21456702E-02 0.21457139E-02 0.10942000E+01 0.64326288E-02 0.21449082E-02 0.21438384E-02 0.21438821E-02 0.10944000E+01 0.64271406E-02 0.21430782E-02 0.21420093E-02 0.21420530E-02 0.10946000E+01 0.64216605E-02 0.21412509E-02 0.21401829E-02 0.21402266E-02 0.10948000E+01 0.64161884E-02 0.21394262E-02 0.21383592E-02 0.21384029E-02 0.10950000E+01 0.64107244E-02 0.21376043E-02 0.21365382E-02 0.21365819E-02 0.10952000E+01 0.64052684E-02 0.21357850E-02 0.21347198E-02 0.21347635E-02 0.10954000E+01 0.63998204E-02 0.21339684E-02 0.21329042E-02 0.21329479E-02 0.10956000E+01 0.63943804E-02 0.21321544E-02 0.21310911E-02 0.21311348E-02 0.10958000E+01 0.63889483E-02 0.21303431E-02 0.21292807E-02 0.21293245E-02 0.10960000E+01 0.63835242E-02 0.21285345E-02 0.21274730E-02 0.21275167E-02 0.10962000E+01 0.63781080E-02 0.21267284E-02 0.21256679E-02 0.21257117E-02 0.10964000E+01 0.63726998E-02 0.21249251E-02 0.21238655E-02 0.21239092E-02 0.10966000E+01 0.63672995E-02 0.21231244E-02 0.21220657E-02 0.21221094E-02 0.10968000E+01 0.63619070E-02 0.21213263E-02 0.21202685E-02 0.21203122E-02 0.10970000E+01 0.63565224E-02 0.21195308E-02 0.21184739E-02 0.21185177E-02 0.10972000E+01 0.63511457E-02 0.21177379E-02 0.21166820E-02 0.21167258E-02 0.10974000E+01 0.63457768E-02 0.21159477E-02 0.21148927E-02 0.21149364E-02 0.10976000E+01 0.63404157E-02 0.21141600E-02 0.21131060E-02 0.21131497E-02 0.10978000E+01 0.63350625E-02 0.21123750E-02 0.21113219E-02 0.21113656E-02 0.10980000E+01 0.63297170E-02 0.21105926E-02 0.21095403E-02 0.21095841E-02 0.10982000E+01 0.63243793E-02 0.21088127E-02 0.21077614E-02 0.21078052E-02 0.10984000E+01 0.63190494E-02 0.21070355E-02 0.21059851E-02 0.21060288E-02 0.10986000E+01 0.63137272E-02 0.21052608E-02 0.21042113E-02 0.21042551E-02 0.10988000E+01 0.63084127E-02 0.21034887E-02 0.21024401E-02 0.21024839E-02 0.10990000E+01 0.63031060E-02 0.21017192E-02 0.21006715E-02 0.21007153E-02 0.10992000E+01 0.62978069E-02 0.20999523E-02 0.20989054E-02 0.20989492E-02 0.10994000E+01 0.62925156E-02 0.20981879E-02 0.20971420E-02 0.20971857E-02 0.10996000E+01 0.62872318E-02 0.20964260E-02 0.20953810E-02 0.20954248E-02 0.10998000E+01 0.62819558E-02 0.20946667E-02 0.20936226E-02 0.20936664E-02 0.11000000E+01 0.62766874E-02 0.20929100E-02 0.20918668E-02 0.20919106E-02 0.11002000E+01 0.62714266E-02 0.20911558E-02 0.20901135E-02 0.20901573E-02 0.11004000E+01 0.62661734E-02 0.20894041E-02 0.20883627E-02 0.20884065E-02 0.11006000E+01 0.62609277E-02 0.20876550E-02 0.20866145E-02 0.20866583E-02 0.11008000E+01 0.62556897E-02 0.20859084E-02 0.20848688E-02 0.20849126E-02 0.11010000E+01 0.62504592E-02 0.20841643E-02 0.20831256E-02 0.20831694E-02 0.11012000E+01 0.62452363E-02 0.20824227E-02 0.20813849E-02 0.20814287E-02 0.11014000E+01 0.62400209E-02 0.20806837E-02 0.20796467E-02 0.20796905E-02 0.11016000E+01 0.62348130E-02 0.20789471E-02 0.20779110E-02 0.20779548E-02 0.11018000E+01 0.62296126E-02 0.20772130E-02 0.20761779E-02 0.20762217E-02 0.11020000E+01 0.62244196E-02 0.20754815E-02 0.20744472E-02 0.20744910E-02 0.11022000E+01 0.62192342E-02 0.20737524E-02 0.20727190E-02 0.20727628E-02 0.11024000E+01 0.62140562E-02 0.20720258E-02 0.20709933E-02 0.20710371E-02 0.11026000E+01 0.62088856E-02 0.20703017E-02 0.20692701E-02 0.20693139E-02 0.11028000E+01 0.62037225E-02 0.20685801E-02 0.20675493E-02 0.20675931E-02 0.11030000E+01 0.61985667E-02 0.20668609E-02 0.20658310E-02 0.20658748E-02 0.11032000E+01 0.61934184E-02 0.20651442E-02 0.20641152E-02 0.20641590E-02 0.11034000E+01 0.61882774E-02 0.20634299E-02 0.20624018E-02 0.20624456E-02 0.11036000E+01 0.61831438E-02 0.20617182E-02 0.20606909E-02 0.20607347E-02 0.11038000E+01 0.61780175E-02 0.20600088E-02 0.20589824E-02 0.20590263E-02 0.11040000E+01 0.61728986E-02 0.20583019E-02 0.20572764E-02 0.20573202E-02 0.11042000E+01 0.61677870E-02 0.20565975E-02 0.20555728E-02 0.20556167E-02 0.11044000E+01 0.61626827E-02 0.20548954E-02 0.20538717E-02 0.20539155E-02 0.11046000E+01 0.61575856E-02 0.20531959E-02 0.20521730E-02 0.20522168E-02 0.11048000E+01 0.61524959E-02 0.20514987E-02 0.20504767E-02 0.20505205E-02 0.11050000E+01 0.61474134E-02 0.20498040E-02 0.20487828E-02 0.20488266E-02 0.11052000E+01 0.61423381E-02 0.20481116E-02 0.20470913E-02 0.20471352E-02 0.11054000E+01 0.61372701E-02 0.20464217E-02 0.20454023E-02 0.20454461E-02 0.11056000E+01 0.61322093E-02 0.20447342E-02 0.20437156E-02 0.20437595E-02 0.11058000E+01 0.61271557E-02 0.20430491E-02 0.20420314E-02 0.20420752E-02 0.11060000E+01 0.61221093E-02 0.20413664E-02 0.20403495E-02 0.20403934E-02 0.11062000E+01 0.61170701E-02 0.20396861E-02 0.20386701E-02 0.20387139E-02 0.11064000E+01 0.61120380E-02 0.20380081E-02 0.20369930E-02 0.20370369E-02 0.11066000E+01 0.61070131E-02 0.20363326E-02 0.20353183E-02 0.20353622E-02 0.11068000E+01 0.61019953E-02 0.20346594E-02 0.20336460E-02 0.20336898E-02 0.11070000E+01 0.60969846E-02 0.20329886E-02 0.20319761E-02 0.20320199E-02 0.11072000E+01 0.60919810E-02 0.20313202E-02 0.20303085E-02 0.20303523E-02 0.11074000E+01 0.60869845E-02 0.20296541E-02 0.20286433E-02 0.20286871E-02 0.11076000E+01 0.60819951E-02 0.20279904E-02 0.20269804E-02 0.20270243E-02 0.11078000E+01 0.60770127E-02 0.20263291E-02 0.20253199E-02 0.20253638E-02 0.11080000E+01 0.60720374E-02 0.20246701E-02 0.20236617E-02 0.20237056E-02 0.11082000E+01 0.60670691E-02 0.20230134E-02 0.20220059E-02 0.20220498E-02 0.11084000E+01 0.60621078E-02 0.20213591E-02 0.20203525E-02 0.20203963E-02 0.11086000E+01 0.60571536E-02 0.20197071E-02 0.20187013E-02 0.20187452E-02 0.11088000E+01 0.60522063E-02 0.20180574E-02 0.20170525E-02 0.20170964E-02 0.11090000E+01 0.60472660E-02 0.20164101E-02 0.20154060E-02 0.20154499E-02 0.11092000E+01 0.60423327E-02 0.20147651E-02 0.20137619E-02 0.20138057E-02 0.11094000E+01 0.60374063E-02 0.20131224E-02 0.20121200E-02 0.20121639E-02 0.11096000E+01 0.60324868E-02 0.20114820E-02 0.20104805E-02 0.20105243E-02 0.11098000E+01 0.60275743E-02 0.20098440E-02 0.20088432E-02 0.20088871E-02 0.11100000E+01 0.60226687E-02 0.20082082E-02 0.20072083E-02 0.20072522E-02 0.11102000E+01 0.60177699E-02 0.20065747E-02 0.20055757E-02 0.20056195E-02 0.11104000E+01 0.60128781E-02 0.20049436E-02 0.20039453E-02 0.20039892E-02 0.11106000E+01 0.60079931E-02 0.20033147E-02 0.20023173E-02 0.20023611E-02 0.11108000E+01 0.60031150E-02 0.20016881E-02 0.20006915E-02 0.20007354E-02 0.11110000E+01 0.59982437E-02 0.20000638E-02 0.19990680E-02 0.19991119E-02 0.11112000E+01 0.59933792E-02 0.19984417E-02 0.19974468E-02 0.19974907E-02 0.11114000E+01 0.59885216E-02 0.19968220E-02 0.19958279E-02 0.19958717E-02 0.11116000E+01 0.59836707E-02 0.19952045E-02 0.19942112E-02 0.19942551E-02 0.11118000E+01 0.59788267E-02 0.19935892E-02 0.19925968E-02 0.19926407E-02 0.11120000E+01 0.59739894E-02 0.19919763E-02 0.19909846E-02 0.19910285E-02 0.11122000E+01 0.59691589E-02 0.19903655E-02 0.19893747E-02 0.19894186E-02 0.11124000E+01 0.59643351E-02 0.19887571E-02 0.19877671E-02 0.19878109E-02 0.11126000E+01 0.59595180E-02 0.19871508E-02 0.19861617E-02 0.19862055E-02 0.11128000E+01 0.59547077E-02 0.19855468E-02 0.19845585E-02 0.19846024E-02 0.11130000E+01 0.59499041E-02 0.19839451E-02 0.19829576E-02 0.19830014E-02 0.11132000E+01 0.59451072E-02 0.19823456E-02 0.19813589E-02 0.19814027E-02 0.11134000E+01 0.59403169E-02 0.19807483E-02 0.19797624E-02 0.19798063E-02 0.11136000E+01 0.59355333E-02 0.19791532E-02 0.19781681E-02 0.19782120E-02 0.11138000E+01 0.59307564E-02 0.19775604E-02 0.19765761E-02 0.19766200E-02 0.11140000E+01 0.59259861E-02 0.19759697E-02 0.19749863E-02 0.19750301E-02 0.11142000E+01 0.59212225E-02 0.19743813E-02 0.19733987E-02 0.19734425E-02 0.11144000E+01 0.59164655E-02 0.19727951E-02 0.19718133E-02 0.19718571E-02 0.11146000E+01 0.59117150E-02 0.19712111E-02 0.19702301E-02 0.19702739E-02 0.11148000E+01 0.59069712E-02 0.19696292E-02 0.19686491E-02 0.19686929E-02 0.11150000E+01 0.59022339E-02 0.19680496E-02 0.19670702E-02 0.19671141E-02 0.11152000E+01 0.58975032E-02 0.19664722E-02 0.19654936E-02 0.19655374E-02 0.11154000E+01 0.58927791E-02 0.19648969E-02 0.19639192E-02 0.19639630E-02 0.11156000E+01 0.58880615E-02 0.19633239E-02 0.19623469E-02 0.19623907E-02 0.11158000E+01 0.58833504E-02 0.19617530E-02 0.19607768E-02 0.19608206E-02 0.11160000E+01 0.58786459E-02 0.19601842E-02 0.19592089E-02 0.19592527E-02 0.11162000E+01 0.58739478E-02 0.19586177E-02 0.19576431E-02 0.19576870E-02 0.11164000E+01 0.58692562E-02 0.19570533E-02 0.19560795E-02 0.19561234E-02 0.11166000E+01 0.58645711E-02 0.19554911E-02 0.19545181E-02 0.19545619E-02 0.11168000E+01 0.58598925E-02 0.19539310E-02 0.19529588E-02 0.19530027E-02 0.11170000E+01 0.58552203E-02 0.19523731E-02 0.19514017E-02 0.19514455E-02 0.11172000E+01 0.58505546E-02 0.19508173E-02 0.19498467E-02 0.19498905E-02 0.11174000E+01 0.58458952E-02 0.19492637E-02 0.19482939E-02 0.19483377E-02 0.11176000E+01 0.58412423E-02 0.19477122E-02 0.19467432E-02 0.19467870E-02 0.11178000E+01 0.58365958E-02 0.19461628E-02 0.19451946E-02 0.19452384E-02 0.11180000E+01 0.58319557E-02 0.19446156E-02 0.19436482E-02 0.19436920E-02 0.11182000E+01 0.58273220E-02 0.19430705E-02 0.19421039E-02 0.19421477E-02 0.11184000E+01 0.58226946E-02 0.19415275E-02 0.19405617E-02 0.19406055E-02 0.11186000E+01 0.58180736E-02 0.19399866E-02 0.19390216E-02 0.19390654E-02 0.11188000E+01 0.58134589E-02 0.19384479E-02 0.19374836E-02 0.19375274E-02 0.11190000E+01 0.58088506E-02 0.19369113E-02 0.19359478E-02 0.19359916E-02 0.11192000E+01 0.58042486E-02 0.19353767E-02 0.19344140E-02 0.19344578E-02 0.11194000E+01 0.57996528E-02 0.19338443E-02 0.19328824E-02 0.19329262E-02 0.11196000E+01 0.57950634E-02 0.19323140E-02 0.19313528E-02 0.19313966E-02 0.11198000E+01 0.57904803E-02 0.19307857E-02 0.19298254E-02 0.19298692E-02 0.11200000E+01 0.57859034E-02 0.19292596E-02 0.19283000E-02 0.19283438E-02 0.11202000E+01 0.57813327E-02 0.19277355E-02 0.19267767E-02 0.19268205E-02 0.11204000E+01 0.57767684E-02 0.19262135E-02 0.19252555E-02 0.19252993E-02 0.11206000E+01 0.57722102E-02 0.19246936E-02 0.19237364E-02 0.19237802E-02 0.11208000E+01 0.57676583E-02 0.19231758E-02 0.19222193E-02 0.19222631E-02 0.11210000E+01 0.57631125E-02 0.19216600E-02 0.19207043E-02 0.19207481E-02 0.11212000E+01 0.57585730E-02 0.19201464E-02 0.19191914E-02 0.19192352E-02 0.11214000E+01 0.57540397E-02 0.19186347E-02 0.19176806E-02 0.19177244E-02 0.11216000E+01 0.57495125E-02 0.19171252E-02 0.19161718E-02 0.19162156E-02 0.11218000E+01 0.57449915E-02 0.19156176E-02 0.19146650E-02 0.19147088E-02 0.11220000E+01 0.57404766E-02 0.19141122E-02 0.19131603E-02 0.19132041E-02 0.11222000E+01 0.57359679E-02 0.19126088E-02 0.19116577E-02 0.19117015E-02 0.11224000E+01 0.57314653E-02 0.19111074E-02 0.19101571E-02 0.19102008E-02 0.11226000E+01 0.57269688E-02 0.19096080E-02 0.19086585E-02 0.19087023E-02 0.11228000E+01 0.57224784E-02 0.19081107E-02 0.19071619E-02 0.19072057E-02 0.11230000E+01 0.57179941E-02 0.19066155E-02 0.19056674E-02 0.19057112E-02 0.11232000E+01 0.57135159E-02 0.19051222E-02 0.19041749E-02 0.19042187E-02 0.11234000E+01 0.57090437E-02 0.19036310E-02 0.19026845E-02 0.19027283E-02 0.11236000E+01 0.57045776E-02 0.19021418E-02 0.19011960E-02 0.19012398E-02 0.11238000E+01 0.57001176E-02 0.19006546E-02 0.18997096E-02 0.18997534E-02 0.11240000E+01 0.56956636E-02 0.18991694E-02 0.18982252E-02 0.18982690E-02 0.11242000E+01 0.56912156E-02 0.18976863E-02 0.18967428E-02 0.18967865E-02 0.11244000E+01 0.56867736E-02 0.18962051E-02 0.18952624E-02 0.18953061E-02 0.11246000E+01 0.56823376E-02 0.18947259E-02 0.18937840E-02 0.18938277E-02 0.11248000E+01 0.56779076E-02 0.18932488E-02 0.18923076E-02 0.18923513E-02 0.11250000E+01 0.56734836E-02 0.18917736E-02 0.18908331E-02 0.18908769E-02 0.11252000E+01 0.56690655E-02 0.18903004E-02 0.18893607E-02 0.18894044E-02 0.11254000E+01 0.56646534E-02 0.18888292E-02 0.18878903E-02 0.18879340E-02 0.11256000E+01 0.56602473E-02 0.18873600E-02 0.18864218E-02 0.18864655E-02 0.11258000E+01 0.56558471E-02 0.18858927E-02 0.18849553E-02 0.18849990E-02 0.11260000E+01 0.56514528E-02 0.18844275E-02 0.18834908E-02 0.18835345E-02 0.11262000E+01 0.56470644E-02 0.18829642E-02 0.18820282E-02 0.18820719E-02 0.11264000E+01 0.56426818E-02 0.18815029E-02 0.18805676E-02 0.18806114E-02 0.11266000E+01 0.56383052E-02 0.18800435E-02 0.18791090E-02 0.18791527E-02 0.11268000E+01 0.56339345E-02 0.18785861E-02 0.18776523E-02 0.18776961E-02 0.11270000E+01 0.56295696E-02 0.18771306E-02 0.18761976E-02 0.18762414E-02 0.11272000E+01 0.56252106E-02 0.18756771E-02 0.18747449E-02 0.18747886E-02 0.11274000E+01 0.56208574E-02 0.18742256E-02 0.18732941E-02 0.18733378E-02 0.11276000E+01 0.56165101E-02 0.18727760E-02 0.18718452E-02 0.18718889E-02 0.11278000E+01 0.56121685E-02 0.18713283E-02 0.18703983E-02 0.18704420E-02 0.11280000E+01 0.56078328E-02 0.18698826E-02 0.18689533E-02 0.18689970E-02 0.11282000E+01 0.56035029E-02 0.18684388E-02 0.18675102E-02 0.18675539E-02 0.11284000E+01 0.55991788E-02 0.18669969E-02 0.18660691E-02 0.18661128E-02 0.11286000E+01 0.55948604E-02 0.18655570E-02 0.18646299E-02 0.18646736E-02 0.11288000E+01 0.55905478E-02 0.18641190E-02 0.18631926E-02 0.18632363E-02 0.11290000E+01 0.55862410E-02 0.18626829E-02 0.18617572E-02 0.18618009E-02 0.11292000E+01 0.55819399E-02 0.18612487E-02 0.18603238E-02 0.18603675E-02 0.11294000E+01 0.55776446E-02 0.18598164E-02 0.18588922E-02 0.18589359E-02 0.11296000E+01 0.55733549E-02 0.18583860E-02 0.18574626E-02 0.18575063E-02 0.11298000E+01 0.55690710E-02 0.18569576E-02 0.18560349E-02 0.18560786E-02 0.11300000E+01 0.55647928E-02 0.18555310E-02 0.18546091E-02 0.18546527E-02 0.11302000E+01 0.55605203E-02 0.18541064E-02 0.18531851E-02 0.18532288E-02 0.11304000E+01 0.55562534E-02 0.18526836E-02 0.18517631E-02 0.18518067E-02 0.11306000E+01 0.55519923E-02 0.18512627E-02 0.18503429E-02 0.18503866E-02 0.11308000E+01 0.55477368E-02 0.18498438E-02 0.18489247E-02 0.18489683E-02 0.11310000E+01 0.55434869E-02 0.18484266E-02 0.18475083E-02 0.18475519E-02 0.11312000E+01 0.55392427E-02 0.18470114E-02 0.18460938E-02 0.18461374E-02 0.11314000E+01 0.55350041E-02 0.18455981E-02 0.18446812E-02 0.18447248E-02 0.11316000E+01 0.55307711E-02 0.18441866E-02 0.18432704E-02 0.18433141E-02 0.11318000E+01 0.55265437E-02 0.18427770E-02 0.18418615E-02 0.18419052E-02 0.11320000E+01 0.55223219E-02 0.18413693E-02 0.18404545E-02 0.18404981E-02 0.11322000E+01 0.55181057E-02 0.18399634E-02 0.18390494E-02 0.18390930E-02 0.11324000E+01 0.55138951E-02 0.18385594E-02 0.18376461E-02 0.18376897E-02 0.11326000E+01 0.55096901E-02 0.18371572E-02 0.18362446E-02 0.18362882E-02 0.11328000E+01 0.55054906E-02 0.18357569E-02 0.18348450E-02 0.18348886E-02 0.11330000E+01 0.55012966E-02 0.18343585E-02 0.18334473E-02 0.18334909E-02 0.11332000E+01 0.54971082E-02 0.18329619E-02 0.18320514E-02 0.18320950E-02 0.11334000E+01 0.54929253E-02 0.18315671E-02 0.18306573E-02 0.18307009E-02 0.11336000E+01 0.54887480E-02 0.18301742E-02 0.18292651E-02 0.18293087E-02 0.11338000E+01 0.54845761E-02 0.18287831E-02 0.18278747E-02 0.18279183E-02 0.11340000E+01 0.54804097E-02 0.18273938E-02 0.18264862E-02 0.18265297E-02 0.11342000E+01 0.54762488E-02 0.18260064E-02 0.18250994E-02 0.18251430E-02 0.11344000E+01 0.54720934E-02 0.18246208E-02 0.18237145E-02 0.18237581E-02 0.11346000E+01 0.54679434E-02 0.18232370E-02 0.18223315E-02 0.18223750E-02 0.11348000E+01 0.54637989E-02 0.18218550E-02 0.18209502E-02 0.18209938E-02 0.11350000E+01 0.54596599E-02 0.18204748E-02 0.18195707E-02 0.18196143E-02 0.11352000E+01 0.54555262E-02 0.18190965E-02 0.18181931E-02 0.18182367E-02 0.11354000E+01 0.54513980E-02 0.18177200E-02 0.18168173E-02 0.18168608E-02 0.11356000E+01 0.54472753E-02 0.18163452E-02 0.18154432E-02 0.18154868E-02 0.11358000E+01 0.54431579E-02 0.18149723E-02 0.18140710E-02 0.18141146E-02 0.11360000E+01 0.54390459E-02 0.18136012E-02 0.18127006E-02 0.18127441E-02 0.11362000E+01 0.54349393E-02 0.18122319E-02 0.18113319E-02 0.18113755E-02 0.11364000E+01 0.54308380E-02 0.18108643E-02 0.18099651E-02 0.18100086E-02 0.11366000E+01 0.54267422E-02 0.18094986E-02 0.18086000E-02 0.18086436E-02 0.11368000E+01 0.54226517E-02 0.18081346E-02 0.18072368E-02 0.18072803E-02 0.11370000E+01 0.54185665E-02 0.18067724E-02 0.18058753E-02 0.18059188E-02 0.11372000E+01 0.54144866E-02 0.18054120E-02 0.18045156E-02 0.18045591E-02 0.11374000E+01 0.54104121E-02 0.18040534E-02 0.18031576E-02 0.18032011E-02 0.11376000E+01 0.54063429E-02 0.18026965E-02 0.18018015E-02 0.18018450E-02 0.11378000E+01 0.54022790E-02 0.18013414E-02 0.18004471E-02 0.18004906E-02 0.11380000E+01 0.53982205E-02 0.17999881E-02 0.17990944E-02 0.17991379E-02 0.11382000E+01 0.53941671E-02 0.17986365E-02 0.17977436E-02 0.17977870E-02 0.11384000E+01 0.53901191E-02 0.17972867E-02 0.17963944E-02 0.17964379E-02 0.11386000E+01 0.53860763E-02 0.17959387E-02 0.17950471E-02 0.17950906E-02 0.11388000E+01 0.53820388E-02 0.17945924E-02 0.17937015E-02 0.17937450E-02 0.11390000E+01 0.53780066E-02 0.17932479E-02 0.17923576E-02 0.17924011E-02 0.11392000E+01 0.53739795E-02 0.17919051E-02 0.17910155E-02 0.17910590E-02 0.11394000E+01 0.53699578E-02 0.17905640E-02 0.17896751E-02 0.17897186E-02 0.11396000E+01 0.53659412E-02 0.17892247E-02 0.17883365E-02 0.17883800E-02 0.11398000E+01 0.53619298E-02 0.17878871E-02 0.17869996E-02 0.17870431E-02 0.11400000E+01 0.53579236E-02 0.17865513E-02 0.17856645E-02 0.17857079E-02 0.11402000E+01 0.53539227E-02 0.17852172E-02 0.17843310E-02 0.17843745E-02 0.11404000E+01 0.53499269E-02 0.17838848E-02 0.17829993E-02 0.17830428E-02 0.11406000E+01 0.53459362E-02 0.17825541E-02 0.17816693E-02 0.17817128E-02 0.11408000E+01 0.53419508E-02 0.17812252E-02 0.17803411E-02 0.17803845E-02 0.11410000E+01 0.53379705E-02 0.17798980E-02 0.17790145E-02 0.17790580E-02 0.11412000E+01 0.53339953E-02 0.17785725E-02 0.17776897E-02 0.17777331E-02 0.11414000E+01 0.53300253E-02 0.17772487E-02 0.17763666E-02 0.17764100E-02 0.11416000E+01 0.53260604E-02 0.17759266E-02 0.17750452E-02 0.17750886E-02 0.11418000E+01 0.53221006E-02 0.17746062E-02 0.17737255E-02 0.17737689E-02 0.11420000E+01 0.53181459E-02 0.17732876E-02 0.17724075E-02 0.17724509E-02 0.11422000E+01 0.53141963E-02 0.17719706E-02 0.17710912E-02 0.17711346E-02 0.11424000E+01 0.53102518E-02 0.17706553E-02 0.17697766E-02 0.17698199E-02 0.11426000E+01 0.53063124E-02 0.17693417E-02 0.17684637E-02 0.17685070E-02 0.11428000E+01 0.53023781E-02 0.17680298E-02 0.17671524E-02 0.17671958E-02 0.11430000E+01 0.52984488E-02 0.17667196E-02 0.17658429E-02 0.17658863E-02 0.11432000E+01 0.52945245E-02 0.17654111E-02 0.17645350E-02 0.17645784E-02 0.11434000E+01 0.52906053E-02 0.17641043E-02 0.17632289E-02 0.17632722E-02 0.11436000E+01 0.52866912E-02 0.17627991E-02 0.17619244E-02 0.17619677E-02 0.11438000E+01 0.52827820E-02 0.17614956E-02 0.17606215E-02 0.17606649E-02 0.11440000E+01 0.52788779E-02 0.17601938E-02 0.17593204E-02 0.17593637E-02 0.11442000E+01 0.52749788E-02 0.17588937E-02 0.17580209E-02 0.17580642E-02 0.11444000E+01 0.52710847E-02 0.17575952E-02 0.17567231E-02 0.17567664E-02 0.11446000E+01 0.52671955E-02 0.17562984E-02 0.17554269E-02 0.17554702E-02 0.11448000E+01 0.52633114E-02 0.17550032E-02 0.17541324E-02 0.17541757E-02 0.11450000E+01 0.52594322E-02 0.17537097E-02 0.17528396E-02 0.17528829E-02 0.11452000E+01 0.52555580E-02 0.17524179E-02 0.17515484E-02 0.17515917E-02 0.11454000E+01 0.52516887E-02 0.17511277E-02 0.17502589E-02 0.17503022E-02 0.11456000E+01 0.52478244E-02 0.17498391E-02 0.17489710E-02 0.17490143E-02 0.11458000E+01 0.52439650E-02 0.17485522E-02 0.17476847E-02 0.17477280E-02 0.11460000E+01 0.52401105E-02 0.17472670E-02 0.17464001E-02 0.17464434E-02 0.11462000E+01 0.52362610E-02 0.17459834E-02 0.17451172E-02 0.17451605E-02 0.11464000E+01 0.52324164E-02 0.17447014E-02 0.17438359E-02 0.17438791E-02 0.11466000E+01 0.52285766E-02 0.17434210E-02 0.17425562E-02 0.17425994E-02 0.11468000E+01 0.52247418E-02 0.17421423E-02 0.17412781E-02 0.17413213E-02 0.11470000E+01 0.52209118E-02 0.17408652E-02 0.17400017E-02 0.17400449E-02 0.11472000E+01 0.52170867E-02 0.17395898E-02 0.17387268E-02 0.17387701E-02 0.11474000E+01 0.52132665E-02 0.17383159E-02 0.17374537E-02 0.17374969E-02 0.11476000E+01 0.52094511E-02 0.17370437E-02 0.17361821E-02 0.17362253E-02 0.11478000E+01 0.52056406E-02 0.17357731E-02 0.17349121E-02 0.17349553E-02 0.11480000E+01 0.52018349E-02 0.17345041E-02 0.17336438E-02 0.17336870E-02 0.11482000E+01 0.51980340E-02 0.17332367E-02 0.17323770E-02 0.17324203E-02 0.11484000E+01 0.51942380E-02 0.17319710E-02 0.17311119E-02 0.17311551E-02 0.11486000E+01 0.51904468E-02 0.17307068E-02 0.17298484E-02 0.17298916E-02 0.11488000E+01 0.51866604E-02 0.17294442E-02 0.17285865E-02 0.17286297E-02 0.11490000E+01 0.51828787E-02 0.17281833E-02 0.17273261E-02 0.17273693E-02 0.11492000E+01 0.51791019E-02 0.17269239E-02 0.17260674E-02 0.17261106E-02 0.11494000E+01 0.51753299E-02 0.17256661E-02 0.17248103E-02 0.17248535E-02 0.11496000E+01 0.51715626E-02 0.17244099E-02 0.17235547E-02 0.17235979E-02 0.11498000E+01 0.51678000E-02 0.17231553E-02 0.17223008E-02 0.17223439E-02 0.11500000E+01 0.51640423E-02 0.17219023E-02 0.17210484E-02 0.17210915E-02 0.11502000E+01 0.51602892E-02 0.17206509E-02 0.17197976E-02 0.17198407E-02 0.11504000E+01 0.51565410E-02 0.17194010E-02 0.17185484E-02 0.17185915E-02 0.11506000E+01 0.51527974E-02 0.17181528E-02 0.17173007E-02 0.17173439E-02 0.11508000E+01 0.51490586E-02 0.17169061E-02 0.17160547E-02 0.17160978E-02 0.11510000E+01 0.51453244E-02 0.17156609E-02 0.17148102E-02 0.17148533E-02 0.11512000E+01 0.51415950E-02 0.17144174E-02 0.17135673E-02 0.17136104E-02 0.11514000E+01 0.51378703E-02 0.17131754E-02 0.17123259E-02 0.17123690E-02 0.11516000E+01 0.51341502E-02 0.17119349E-02 0.17110861E-02 0.17111292E-02 0.11518000E+01 0.51304349E-02 0.17106961E-02 0.17098478E-02 0.17098909E-02 0.11520000E+01 0.51267242E-02 0.17094588E-02 0.17086112E-02 0.17086542E-02 0.11522000E+01 0.51230181E-02 0.17082230E-02 0.17073760E-02 0.17074191E-02 0.11524000E+01 0.51193167E-02 0.17069888E-02 0.17061424E-02 0.17061855E-02 0.11526000E+01 0.51156200E-02 0.17057561E-02 0.17049104E-02 0.17049535E-02 0.11528000E+01 0.51119279E-02 0.17045250E-02 0.17036799E-02 0.17037230E-02 0.11530000E+01 0.51082404E-02 0.17032954E-02 0.17024510E-02 0.17024940E-02 0.11532000E+01 0.51045576E-02 0.17020674E-02 0.17012236E-02 0.17012666E-02 0.11534000E+01 0.51008794E-02 0.17008409E-02 0.16999977E-02 0.17000407E-02 0.11536000E+01 0.50972057E-02 0.16996160E-02 0.16987734E-02 0.16988164E-02 0.11538000E+01 0.50935367E-02 0.16983925E-02 0.16975506E-02 0.16975936E-02 0.11540000E+01 0.50898722E-02 0.16971706E-02 0.16963293E-02 0.16963723E-02 0.11542000E+01 0.50862124E-02 0.16959503E-02 0.16951095E-02 0.16951526E-02 0.11544000E+01 0.50825571E-02 0.16947314E-02 0.16938913E-02 0.16939343E-02 0.11546000E+01 0.50789064E-02 0.16935141E-02 0.16926746E-02 0.16927176E-02 0.11548000E+01 0.50752602E-02 0.16922983E-02 0.16914594E-02 0.16915024E-02 0.11550000E+01 0.50716186E-02 0.16910840E-02 0.16902458E-02 0.16902888E-02 0.11552000E+01 0.50679815E-02 0.16898713E-02 0.16890336E-02 0.16890766E-02 0.11554000E+01 0.50643489E-02 0.16886600E-02 0.16878230E-02 0.16878660E-02 0.11556000E+01 0.50607209E-02 0.16874503E-02 0.16866138E-02 0.16866568E-02 0.11558000E+01 0.50570974E-02 0.16862420E-02 0.16854062E-02 0.16854492E-02 0.11560000E+01 0.50534784E-02 0.16850353E-02 0.16842001E-02 0.16842430E-02 0.11562000E+01 0.50498639E-02 0.16838300E-02 0.16829955E-02 0.16830384E-02 0.11564000E+01 0.50462539E-02 0.16826263E-02 0.16817923E-02 0.16818353E-02 0.11566000E+01 0.50426484E-02 0.16814240E-02 0.16805907E-02 0.16806336E-02 0.11568000E+01 0.50390473E-02 0.16802233E-02 0.16793906E-02 0.16794335E-02 0.11570000E+01 0.50354508E-02 0.16790240E-02 0.16781919E-02 0.16782348E-02 0.11572000E+01 0.50318587E-02 0.16778263E-02 0.16769947E-02 0.16770377E-02 0.11574000E+01 0.50282710E-02 0.16766300E-02 0.16757991E-02 0.16758420E-02 0.11576000E+01 0.50246878E-02 0.16754352E-02 0.16746049E-02 0.16746478E-02 0.11578000E+01 0.50211090E-02 0.16742418E-02 0.16734121E-02 0.16734550E-02 0.11580000E+01 0.50175347E-02 0.16730500E-02 0.16722209E-02 0.16722638E-02 0.11582000E+01 0.50139648E-02 0.16718596E-02 0.16710311E-02 0.16710740E-02 0.11584000E+01 0.50103993E-02 0.16706707E-02 0.16698428E-02 0.16698857E-02 0.11586000E+01 0.50068382E-02 0.16694833E-02 0.16686560E-02 0.16686989E-02 0.11588000E+01 0.50032815E-02 0.16682973E-02 0.16674707E-02 0.16675135E-02 0.11590000E+01 0.49997292E-02 0.16671128E-02 0.16662868E-02 0.16663296E-02 0.11592000E+01 0.49961813E-02 0.16659298E-02 0.16651043E-02 0.16651472E-02 0.11594000E+01 0.49926377E-02 0.16647482E-02 0.16639233E-02 0.16639662E-02 0.11596000E+01 0.49890986E-02 0.16635681E-02 0.16627438E-02 0.16627867E-02 0.11598000E+01 0.49855638E-02 0.16623894E-02 0.16615658E-02 0.16616086E-02 0.11600000E+01 0.49820333E-02 0.16612122E-02 0.16603891E-02 0.16604320E-02 0.11602000E+01 0.49785072E-02 0.16600365E-02 0.16592140E-02 0.16592568E-02 0.11604000E+01 0.49749855E-02 0.16588621E-02 0.16580403E-02 0.16580831E-02 0.11606000E+01 0.49714680E-02 0.16576893E-02 0.16568680E-02 0.16569108E-02 0.11608000E+01 0.49679549E-02 0.16565178E-02 0.16556971E-02 0.16557399E-02 0.11610000E+01 0.49644461E-02 0.16553478E-02 0.16545278E-02 0.16545705E-02 0.11612000E+01 0.49609417E-02 0.16541793E-02 0.16533598E-02 0.16534026E-02 0.11614000E+01 0.49574415E-02 0.16530122E-02 0.16521933E-02 0.16522360E-02 0.11616000E+01 0.49539456E-02 0.16518465E-02 0.16510282E-02 0.16510709E-02 0.11618000E+01 0.49504540E-02 0.16506822E-02 0.16498645E-02 0.16499073E-02 0.11620000E+01 0.49469667E-02 0.16495194E-02 0.16487023E-02 0.16487450E-02 0.11622000E+01 0.49434837E-02 0.16483580E-02 0.16475415E-02 0.16475842E-02 0.11624000E+01 0.49400049E-02 0.16471980E-02 0.16463821E-02 0.16464248E-02 0.11626000E+01 0.49365304E-02 0.16460395E-02 0.16452241E-02 0.16452668E-02 0.11628000E+01 0.49330601E-02 0.16448823E-02 0.16440675E-02 0.16441102E-02 0.11630000E+01 0.49295941E-02 0.16437266E-02 0.16429124E-02 0.16429551E-02 0.11632000E+01 0.49261323E-02 0.16425723E-02 0.16417587E-02 0.16418014E-02 0.11634000E+01 0.49226747E-02 0.16414194E-02 0.16406063E-02 0.16406490E-02 0.11636000E+01 0.49192214E-02 0.16402679E-02 0.16394554E-02 0.16394981E-02 0.11638000E+01 0.49157723E-02 0.16391178E-02 0.16383059E-02 0.16383486E-02 0.11640000E+01 0.49123274E-02 0.16379691E-02 0.16371578E-02 0.16372005E-02 0.11642000E+01 0.49088867E-02 0.16368218E-02 0.16360111E-02 0.16360538E-02 0.11644000E+01 0.49054502E-02 0.16356759E-02 0.16348658E-02 0.16349085E-02 0.11646000E+01 0.49020178E-02 0.16345314E-02 0.16337219E-02 0.16337645E-02 0.11648000E+01 0.48985897E-02 0.16333883E-02 0.16325794E-02 0.16326220E-02 0.11650000E+01 0.48951657E-02 0.16322466E-02 0.16314382E-02 0.16314809E-02 0.11652000E+01 0.48917459E-02 0.16311063E-02 0.16302985E-02 0.16303411E-02 0.11654000E+01 0.48883302E-02 0.16299673E-02 0.16291601E-02 0.16292027E-02 0.11656000E+01 0.48849187E-02 0.16288298E-02 0.16280232E-02 0.16280658E-02 0.11658000E+01 0.48815114E-02 0.16276936E-02 0.16268876E-02 0.16269302E-02 0.11660000E+01 0.48781081E-02 0.16265588E-02 0.16257534E-02 0.16257959E-02 0.11662000E+01 0.48747090E-02 0.16254254E-02 0.16246205E-02 0.16246631E-02 0.11664000E+01 0.48713141E-02 0.16242934E-02 0.16234891E-02 0.16235316E-02 0.11666000E+01 0.48679232E-02 0.16231627E-02 0.16223590E-02 0.16224015E-02 0.11668000E+01 0.48645364E-02 0.16220334E-02 0.16212302E-02 0.16212728E-02 0.11670000E+01 0.48611538E-02 0.16209055E-02 0.16201029E-02 0.16201454E-02 0.11672000E+01 0.48577752E-02 0.16197789E-02 0.16189769E-02 0.16190194E-02 0.11674000E+01 0.48544008E-02 0.16186537E-02 0.16178523E-02 0.16178948E-02 0.11676000E+01 0.48510304E-02 0.16175299E-02 0.16167290E-02 0.16167715E-02 0.11678000E+01 0.48476641E-02 0.16164074E-02 0.16156071E-02 0.16156496E-02 0.11680000E+01 0.48443018E-02 0.16152863E-02 0.16144865E-02 0.16145290E-02 0.11682000E+01 0.48409436E-02 0.16141665E-02 0.16133673E-02 0.16134098E-02 0.11684000E+01 0.48375895E-02 0.16130481E-02 0.16122495E-02 0.16122920E-02 0.11686000E+01 0.48342394E-02 0.16119310E-02 0.16111330E-02 0.16111754E-02 0.11688000E+01 0.48308933E-02 0.16108153E-02 0.16100178E-02 0.16100603E-02 0.11690000E+01 0.48275513E-02 0.16097009E-02 0.16089040E-02 0.16089464E-02 0.11692000E+01 0.48242133E-02 0.16085879E-02 0.16077915E-02 0.16078340E-02 0.11694000E+01 0.48208793E-02 0.16074762E-02 0.16066804E-02 0.16067228E-02 0.11696000E+01 0.48175494E-02 0.16063658E-02 0.16055706E-02 0.16056130E-02 0.11698000E+01 0.48142234E-02 0.16052568E-02 0.16044621E-02 0.16045045E-02 0.11700000E+01 0.48109015E-02 0.16041491E-02 0.16033550E-02 0.16033974E-02 0.11702000E+01 0.48075835E-02 0.16030427E-02 0.16022492E-02 0.16022916E-02 0.11704000E+01 0.48042695E-02 0.16019377E-02 0.16011447E-02 0.16011871E-02 0.11706000E+01 0.48009595E-02 0.16008340E-02 0.16000416E-02 0.16000840E-02 0.11708000E+01 0.47976535E-02 0.15997316E-02 0.15989397E-02 0.15989821E-02 0.11710000E+01 0.47943514E-02 0.15986305E-02 0.15978392E-02 0.15978816E-02 0.11712000E+01 0.47910533E-02 0.15975308E-02 0.15967401E-02 0.15967824E-02 0.11714000E+01 0.47877591E-02 0.15964324E-02 0.15956422E-02 0.15956846E-02 0.11716000E+01 0.47844689E-02 0.15953353E-02 0.15945456E-02 0.15945880E-02 0.11718000E+01 0.47811826E-02 0.15942395E-02 0.15934504E-02 0.15934928E-02 0.11720000E+01 0.47779003E-02 0.15931450E-02 0.15923565E-02 0.15923988E-02 0.11722000E+01 0.47746218E-02 0.15920518E-02 0.15912639E-02 0.15913062E-02 0.11724000E+01 0.47713473E-02 0.15909599E-02 0.15901725E-02 0.15902149E-02 0.11726000E+01 0.47680768E-02 0.15898694E-02 0.15890825E-02 0.15891248E-02 0.11728000E+01 0.47648101E-02 0.15887801E-02 0.15879938E-02 0.15880361E-02 0.11730000E+01 0.47615473E-02 0.15876922E-02 0.15869064E-02 0.15869487E-02 0.11732000E+01 0.47582884E-02 0.15866055E-02 0.15858203E-02 0.15858626E-02 0.11734000E+01 0.47550334E-02 0.15855201E-02 0.15847355E-02 0.15847778E-02 0.11736000E+01 0.47517822E-02 0.15844360E-02 0.15836520E-02 0.15836942E-02 0.11738000E+01 0.47485350E-02 0.15833533E-02 0.15825697E-02 0.15826120E-02 0.11740000E+01 0.47452916E-02 0.15822718E-02 0.15814888E-02 0.15815310E-02 0.11742000E+01 0.47420521E-02 0.15811916E-02 0.15804091E-02 0.15804514E-02 0.11744000E+01 0.47388164E-02 0.15801126E-02 0.15793307E-02 0.15793730E-02 0.11746000E+01 0.47355845E-02 0.15790350E-02 0.15782536E-02 0.15782959E-02 0.11748000E+01 0.47323565E-02 0.15779586E-02 0.15771778E-02 0.15772201E-02 0.11750000E+01 0.47291324E-02 0.15768836E-02 0.15761033E-02 0.15761455E-02 0.11752000E+01 0.47259121E-02 0.15758098E-02 0.15750300E-02 0.15750723E-02 0.11754000E+01 0.47226955E-02 0.15747372E-02 0.15739581E-02 0.15740003E-02 0.11756000E+01 0.47194829E-02 0.15736660E-02 0.15728873E-02 0.15729295E-02 0.11758000E+01 0.47162740E-02 0.15725960E-02 0.15718179E-02 0.15718601E-02 0.11760000E+01 0.47130689E-02 0.15715273E-02 0.15707497E-02 0.15707919E-02 0.11762000E+01 0.47098676E-02 0.15704598E-02 0.15696828E-02 0.15697250E-02 0.11764000E+01 0.47066701E-02 0.15693936E-02 0.15686172E-02 0.15686593E-02 0.11766000E+01 0.47034764E-02 0.15683287E-02 0.15675528E-02 0.15675949E-02 0.11768000E+01 0.47002864E-02 0.15672650E-02 0.15664896E-02 0.15665318E-02 0.11770000E+01 0.46971003E-02 0.15662026E-02 0.15654278E-02 0.15654699E-02 0.11772000E+01 0.46939179E-02 0.15651414E-02 0.15643671E-02 0.15644093E-02 0.11774000E+01 0.46907392E-02 0.15640815E-02 0.15633078E-02 0.15633499E-02 0.11776000E+01 0.46875643E-02 0.15630229E-02 0.15622497E-02 0.15622918E-02 0.11778000E+01 0.46843932E-02 0.15619655E-02 0.15611928E-02 0.15612349E-02 0.11780000E+01 0.46812258E-02 0.15609093E-02 0.15601372E-02 0.15601793E-02 0.11782000E+01 0.46780621E-02 0.15598544E-02 0.15590828E-02 0.15591249E-02 0.11784000E+01 0.46749022E-02 0.15588008E-02 0.15580297E-02 0.15580717E-02 0.11786000E+01 0.46717459E-02 0.15577483E-02 0.15569778E-02 0.15570198E-02 0.11788000E+01 0.46685934E-02 0.15566971E-02 0.15559271E-02 0.15559692E-02 0.11790000E+01 0.46654446E-02 0.15556472E-02 0.15548777E-02 0.15549197E-02 0.11792000E+01 0.46622995E-02 0.15545985E-02 0.15538295E-02 0.15538715E-02 0.11794000E+01 0.46591581E-02 0.15535510E-02 0.15527826E-02 0.15528246E-02 0.11796000E+01 0.46560204E-02 0.15525047E-02 0.15517368E-02 0.15517789E-02 0.11798000E+01 0.46528864E-02 0.15514597E-02 0.15506923E-02 0.15507343E-02 0.11800000E+01 0.46497560E-02 0.15504159E-02 0.15496491E-02 0.15496911E-02 0.11802000E+01 0.46466293E-02 0.15493733E-02 0.15486070E-02 0.15486490E-02 0.11804000E+01 0.46435063E-02 0.15483320E-02 0.15475662E-02 0.15476082E-02 0.11806000E+01 0.46403870E-02 0.15472918E-02 0.15465266E-02 0.15465686E-02 0.11808000E+01 0.46372713E-02 0.15462529E-02 0.15454882E-02 0.15455302E-02 0.11810000E+01 0.46341592E-02 0.15452152E-02 0.15444510E-02 0.15444930E-02 0.11812000E+01 0.46310508E-02 0.15441787E-02 0.15434151E-02 0.15434570E-02 0.11814000E+01 0.46279461E-02 0.15431435E-02 0.15423803E-02 0.15424223E-02 0.11816000E+01 0.46248449E-02 0.15421094E-02 0.15413468E-02 0.15413887E-02 0.11818000E+01 0.46217474E-02 0.15410766E-02 0.15403145E-02 0.15403564E-02 0.11820000E+01 0.46186535E-02 0.15400449E-02 0.15392833E-02 0.15393253E-02 0.11822000E+01 0.46155632E-02 0.15390145E-02 0.15382534E-02 0.15382953E-02 0.11824000E+01 0.46124765E-02 0.15379852E-02 0.15372247E-02 0.15372666E-02 0.11826000E+01 0.46093935E-02 0.15369572E-02 0.15361972E-02 0.15362391E-02 0.11828000E+01 0.46063140E-02 0.15359304E-02 0.15351709E-02 0.15352128E-02 0.11830000E+01 0.46032381E-02 0.15349047E-02 0.15341457E-02 0.15341876E-02 0.11832000E+01 0.46001658E-02 0.15338803E-02 0.15331218E-02 0.15331637E-02 0.11834000E+01 0.45970970E-02 0.15328570E-02 0.15320991E-02 0.15321409E-02 0.11836000E+01 0.45940319E-02 0.15318349E-02 0.15310775E-02 0.15311194E-02 0.11838000E+01 0.45909703E-02 0.15308141E-02 0.15300572E-02 0.15300990E-02 0.11840000E+01 0.45879122E-02 0.15297944E-02 0.15290380E-02 0.15290798E-02 0.11842000E+01 0.45848577E-02 0.15287759E-02 0.15280200E-02 0.15280618E-02 0.11844000E+01 0.45818068E-02 0.15277586E-02 0.15270032E-02 0.15270450E-02 0.11846000E+01 0.45787594E-02 0.15267424E-02 0.15259876E-02 0.15260294E-02 0.11848000E+01 0.45757155E-02 0.15257275E-02 0.15249731E-02 0.15250149E-02 0.11850000E+01 0.45726752E-02 0.15247137E-02 0.15239599E-02 0.15240017E-02 0.11852000E+01 0.45696384E-02 0.15237011E-02 0.15229478E-02 0.15229896E-02 0.11854000E+01 0.45666051E-02 0.15226896E-02 0.15219369E-02 0.15219786E-02 0.11856000E+01 0.45635754E-02 0.15216794E-02 0.15209271E-02 0.15209689E-02 0.11858000E+01 0.45605491E-02 0.15206703E-02 0.15199185E-02 0.15199603E-02 0.11860000E+01 0.45575263E-02 0.15196624E-02 0.15189111E-02 0.15189529E-02 0.11862000E+01 0.45545071E-02 0.15186556E-02 0.15179049E-02 0.15179466E-02 0.11864000E+01 0.45514913E-02 0.15176500E-02 0.15168998E-02 0.15169415E-02 0.11866000E+01 0.45484790E-02 0.15166456E-02 0.15158959E-02 0.15159376E-02 0.11868000E+01 0.45454702E-02 0.15156423E-02 0.15148931E-02 0.15149348E-02 0.11870000E+01 0.45424649E-02 0.15146402E-02 0.15138915E-02 0.15139332E-02 0.11872000E+01 0.45394630E-02 0.15136392E-02 0.15128910E-02 0.15129327E-02 0.11874000E+01 0.45364646E-02 0.15126394E-02 0.15118917E-02 0.15119334E-02 0.11876000E+01 0.45334696E-02 0.15116408E-02 0.15108936E-02 0.15109353E-02 0.11878000E+01 0.45304781E-02 0.15106433E-02 0.15098966E-02 0.15099383E-02 0.11880000E+01 0.45274901E-02 0.15096469E-02 0.15089008E-02 0.15089424E-02 0.11882000E+01 0.45245055E-02 0.15086517E-02 0.15079061E-02 0.15079477E-02 0.11884000E+01 0.45215243E-02 0.15076577E-02 0.15069125E-02 0.15069541E-02 0.11886000E+01 0.45185465E-02 0.15066647E-02 0.15059201E-02 0.15059617E-02 0.11888000E+01 0.45155722E-02 0.15056730E-02 0.15049288E-02 0.15049704E-02 0.11890000E+01 0.45126013E-02 0.15046823E-02 0.15039387E-02 0.15039803E-02 0.11892000E+01 0.45096338E-02 0.15036928E-02 0.15029497E-02 0.15029913E-02 0.11894000E+01 0.45066697E-02 0.15027045E-02 0.15019618E-02 0.15020034E-02 0.11896000E+01 0.45037090E-02 0.15017173E-02 0.15009751E-02 0.15010167E-02 0.11898000E+01 0.45007518E-02 0.15007312E-02 0.14999895E-02 0.15000311E-02 0.11900000E+01 0.44977979E-02 0.14997462E-02 0.14990050E-02 0.14990466E-02 0.11902000E+01 0.44948473E-02 0.14987624E-02 0.14980217E-02 0.14980633E-02 0.11904000E+01 0.44919002E-02 0.14977797E-02 0.14970395E-02 0.14970810E-02 0.11906000E+01 0.44889564E-02 0.14967981E-02 0.14960584E-02 0.14960999E-02 0.11908000E+01 0.44860160E-02 0.14958176E-02 0.14950785E-02 0.14951200E-02 0.11910000E+01 0.44830790E-02 0.14948383E-02 0.14940996E-02 0.14941411E-02 0.11912000E+01 0.44801453E-02 0.14938601E-02 0.14931219E-02 0.14931634E-02 0.11914000E+01 0.44772150E-02 0.14928830E-02 0.14921453E-02 0.14921868E-02 0.11916000E+01 0.44742881E-02 0.14919070E-02 0.14911698E-02 0.14912113E-02 0.11918000E+01 0.44713644E-02 0.14909321E-02 0.14901954E-02 0.14902369E-02 0.11920000E+01 0.44684441E-02 0.14899584E-02 0.14892222E-02 0.14892636E-02 0.11922000E+01 0.44655272E-02 0.14889857E-02 0.14882500E-02 0.14882915E-02 0.11924000E+01 0.44626135E-02 0.14880142E-02 0.14872790E-02 0.14873204E-02 0.11926000E+01 0.44597032E-02 0.14870437E-02 0.14863090E-02 0.14863505E-02 0.11928000E+01 0.44567962E-02 0.14860744E-02 0.14853402E-02 0.14853816E-02 0.11930000E+01 0.44538925E-02 0.14851062E-02 0.14843724E-02 0.14844139E-02 0.11932000E+01 0.44509921E-02 0.14841391E-02 0.14834058E-02 0.14834472E-02 0.11934000E+01 0.44480950E-02 0.14831731E-02 0.14824403E-02 0.14824817E-02 0.11936000E+01 0.44452013E-02 0.14822081E-02 0.14814759E-02 0.14815173E-02 0.11938000E+01 0.44423107E-02 0.14812443E-02 0.14805125E-02 0.14805539E-02 0.11940000E+01 0.44394235E-02 0.14802816E-02 0.14795503E-02 0.14795917E-02 0.11942000E+01 0.44365396E-02 0.14793199E-02 0.14785891E-02 0.14786305E-02 0.11944000E+01 0.44336589E-02 0.14783594E-02 0.14776291E-02 0.14776704E-02 0.11946000E+01 0.44307815E-02 0.14773999E-02 0.14766701E-02 0.14767115E-02 0.11948000E+01 0.44279074E-02 0.14764416E-02 0.14757122E-02 0.14757536E-02 0.11950000E+01 0.44250365E-02 0.14754843E-02 0.14747554E-02 0.14747968E-02 0.11952000E+01 0.44221689E-02 0.14745281E-02 0.14737997E-02 0.14738410E-02 0.11954000E+01 0.44193045E-02 0.14735730E-02 0.14728451E-02 0.14728864E-02 0.11956000E+01 0.44164433E-02 0.14726190E-02 0.14718915E-02 0.14719328E-02 0.11958000E+01 0.44135854E-02 0.14716660E-02 0.14709391E-02 0.14709804E-02 0.11960000E+01 0.44107307E-02 0.14707141E-02 0.14699877E-02 0.14700290E-02 0.11962000E+01 0.44078793E-02 0.14697633E-02 0.14690373E-02 0.14690786E-02 0.11964000E+01 0.44050311E-02 0.14688136E-02 0.14680881E-02 0.14681294E-02 0.11966000E+01 0.44021861E-02 0.14678649E-02 0.14671399E-02 0.14671812E-02 0.11968000E+01 0.43993443E-02 0.14669174E-02 0.14661928E-02 0.14662341E-02 0.11970000E+01 0.43965057E-02 0.14659708E-02 0.14652468E-02 0.14652880E-02 0.11972000E+01 0.43936703E-02 0.14650254E-02 0.14643018E-02 0.14643431E-02 0.11974000E+01 0.43908381E-02 0.14640810E-02 0.14633579E-02 0.14633991E-02 0.11976000E+01 0.43880091E-02 0.14631377E-02 0.14624151E-02 0.14624563E-02 0.11978000E+01 0.43851833E-02 0.14621955E-02 0.14614733E-02 0.14615145E-02 0.11980000E+01 0.43823606E-02 0.14612543E-02 0.14605326E-02 0.14605738E-02 0.11982000E+01 0.43795412E-02 0.14603141E-02 0.14595929E-02 0.14596341E-02 0.11984000E+01 0.43767249E-02 0.14593750E-02 0.14586543E-02 0.14586955E-02 0.11986000E+01 0.43739117E-02 0.14584370E-02 0.14577168E-02 0.14577579E-02 0.11988000E+01 0.43711018E-02 0.14575001E-02 0.14567803E-02 0.14568214E-02 0.11990000E+01 0.43682950E-02 0.14565641E-02 0.14558448E-02 0.14558860E-02 0.11992000E+01 0.43654913E-02 0.14556293E-02 0.14549105E-02 0.14549516E-02 0.11994000E+01 0.43626908E-02 0.14546955E-02 0.14539771E-02 0.14540182E-02 0.11996000E+01 0.43598934E-02 0.14537627E-02 0.14530448E-02 0.14530859E-02 0.11998000E+01 0.43570992E-02 0.14528310E-02 0.14521136E-02 0.14521547E-02 0.12000000E+01 0.43543081E-02 0.14519003E-02 0.14511833E-02 0.14512244E-02 0.12002000E+01 0.43515201E-02 0.14509706E-02 0.14502542E-02 0.14502953E-02 0.12004000E+01 0.43487352E-02 0.14500421E-02 0.14493261E-02 0.14493671E-02 0.12006000E+01 0.43459535E-02 0.14491145E-02 0.14483990E-02 0.14484400E-02 0.12008000E+01 0.43431749E-02 0.14481880E-02 0.14474729E-02 0.14475140E-02 0.12010000E+01 0.43403993E-02 0.14472625E-02 0.14465479E-02 0.14465890E-02 0.12012000E+01 0.43376269E-02 0.14463380E-02 0.14456239E-02 0.14456650E-02 0.12014000E+01 0.43348576E-02 0.14454146E-02 0.14447010E-02 0.14447420E-02 0.12016000E+01 0.43320914E-02 0.14444922E-02 0.14437791E-02 0.14438201E-02 0.12018000E+01 0.43293282E-02 0.14435709E-02 0.14428582E-02 0.14428992E-02 0.12020000E+01 0.43265681E-02 0.14426506E-02 0.14419383E-02 0.14419793E-02 0.12022000E+01 0.43238112E-02 0.14417312E-02 0.14410195E-02 0.14410605E-02 0.12024000E+01 0.43210572E-02 0.14408130E-02 0.14401016E-02 0.14401426E-02 0.12026000E+01 0.43183064E-02 0.14398957E-02 0.14391849E-02 0.14392258E-02 0.12028000E+01 0.43155586E-02 0.14389795E-02 0.14382691E-02 0.14383100E-02 0.12030000E+01 0.43128139E-02 0.14380643E-02 0.14373543E-02 0.14373953E-02 0.12032000E+01 0.43100722E-02 0.14371501E-02 0.14364406E-02 0.14364815E-02 0.12034000E+01 0.43073336E-02 0.14362369E-02 0.14355279E-02 0.14355688E-02 0.12036000E+01 0.43045980E-02 0.14353247E-02 0.14346162E-02 0.14346571E-02 0.12038000E+01 0.43018655E-02 0.14344136E-02 0.14337055E-02 0.14337464E-02 0.12040000E+01 0.42991360E-02 0.14335034E-02 0.14327958E-02 0.14328367E-02 0.12042000E+01 0.42964095E-02 0.14325943E-02 0.14318871E-02 0.14319280E-02 0.12044000E+01 0.42936860E-02 0.14316862E-02 0.14309795E-02 0.14310204E-02 0.12046000E+01 0.42909656E-02 0.14307791E-02 0.14300728E-02 0.14301137E-02 0.12048000E+01 0.42882482E-02 0.14298730E-02 0.14291672E-02 0.14292080E-02 0.12050000E+01 0.42855338E-02 0.14289679E-02 0.14282625E-02 0.14283034E-02 0.12052000E+01 0.42828224E-02 0.14280638E-02 0.14273589E-02 0.14273997E-02 0.12054000E+01 0.42801140E-02 0.14271607E-02 0.14264562E-02 0.14264971E-02 0.12056000E+01 0.42774086E-02 0.14262586E-02 0.14255546E-02 0.14255954E-02 0.12058000E+01 0.42747061E-02 0.14253574E-02 0.14246539E-02 0.14246948E-02 0.12060000E+01 0.42720067E-02 0.14244573E-02 0.14237543E-02 0.14237951E-02 0.12062000E+01 0.42693103E-02 0.14235582E-02 0.14228556E-02 0.14228964E-02 0.12064000E+01 0.42666168E-02 0.14226601E-02 0.14219580E-02 0.14219987E-02 0.12066000E+01 0.42639263E-02 0.14217630E-02 0.14210613E-02 0.14211021E-02 0.12068000E+01 0.42612388E-02 0.14208668E-02 0.14201656E-02 0.14202064E-02 0.12070000E+01 0.42585542E-02 0.14199717E-02 0.14192709E-02 0.14193117E-02 0.12072000E+01 0.42558726E-02 0.14190775E-02 0.14183772E-02 0.14184179E-02 0.12074000E+01 0.42531940E-02 0.14181843E-02 0.14174845E-02 0.14175252E-02 0.12076000E+01 0.42505183E-02 0.14172921E-02 0.14165927E-02 0.14166334E-02 0.12078000E+01 0.42478456E-02 0.14164009E-02 0.14157020E-02 0.14157427E-02 0.12080000E+01 0.42451758E-02 0.14155107E-02 0.14148122E-02 0.14148529E-02 0.12082000E+01 0.42425089E-02 0.14146215E-02 0.14139234E-02 0.14139641E-02 0.12084000E+01 0.42398450E-02 0.14137332E-02 0.14130355E-02 0.14130762E-02 0.12086000E+01 0.42371840E-02 0.14128459E-02 0.14121487E-02 0.14121894E-02 0.12088000E+01 0.42345259E-02 0.14119596E-02 0.14112628E-02 0.14113035E-02 0.12090000E+01 0.42318707E-02 0.14110742E-02 0.14103779E-02 0.14104186E-02 0.12092000E+01 0.42292185E-02 0.14101898E-02 0.14094940E-02 0.14095346E-02 0.12094000E+01 0.42265691E-02 0.14093064E-02 0.14086110E-02 0.14086517E-02 0.12096000E+01 0.42239227E-02 0.14084240E-02 0.14077290E-02 0.14077697E-02 0.12098000E+01 0.42212791E-02 0.14075425E-02 0.14068480E-02 0.14068886E-02 0.12100000E+01 0.42186385E-02 0.14066620E-02 0.14059679E-02 0.14060086E-02 0.12102000E+01 0.42160008E-02 0.14057825E-02 0.14050888E-02 0.14051295E-02 0.12104000E+01 0.42133659E-02 0.14049039E-02 0.14042107E-02 0.14042513E-02 0.12106000E+01 0.42107339E-02 0.14040263E-02 0.14033335E-02 0.14033741E-02 0.12108000E+01 0.42081048E-02 0.14031496E-02 0.14024573E-02 0.14024979E-02 0.12110000E+01 0.42054786E-02 0.14022739E-02 0.14015821E-02 0.14016226E-02 0.12112000E+01 0.42028552E-02 0.14013992E-02 0.14007078E-02 0.14007483E-02 0.12114000E+01 0.42002348E-02 0.14005254E-02 0.13998344E-02 0.13998750E-02 0.12116000E+01 0.41976171E-02 0.13996525E-02 0.13989620E-02 0.13990026E-02 0.12118000E+01 0.41950024E-02 0.13987807E-02 0.13980906E-02 0.13981311E-02 0.12120000E+01 0.41923904E-02 0.13979097E-02 0.13972201E-02 0.13972606E-02 0.12122000E+01 0.41897814E-02 0.13970397E-02 0.13963506E-02 0.13963911E-02 0.12124000E+01 0.41871751E-02 0.13961707E-02 0.13954820E-02 0.13955225E-02 0.12126000E+01 0.41845718E-02 0.13953026E-02 0.13946143E-02 0.13946548E-02 0.12128000E+01 0.41819712E-02 0.13944355E-02 0.13937476E-02 0.13937881E-02 0.12130000E+01 0.41793735E-02 0.13935693E-02 0.13928819E-02 0.13929223E-02 0.12132000E+01 0.41767786E-02 0.13927040E-02 0.13920170E-02 0.13920575E-02 0.12134000E+01 0.41741865E-02 0.13918397E-02 0.13911532E-02 0.13911936E-02 0.12136000E+01 0.41715972E-02 0.13909764E-02 0.13902902E-02 0.13903307E-02 0.12138000E+01 0.41690108E-02 0.13901139E-02 0.13894282E-02 0.13894687E-02 0.12140000E+01 0.41664272E-02 0.13892524E-02 0.13885672E-02 0.13886076E-02 0.12142000E+01 0.41638463E-02 0.13883919E-02 0.13877070E-02 0.13877474E-02 0.12144000E+01 0.41612683E-02 0.13875322E-02 0.13868478E-02 0.13868882E-02 0.12146000E+01 0.41586931E-02 0.13866735E-02 0.13859896E-02 0.13860300E-02 0.12148000E+01 0.41561206E-02 0.13858158E-02 0.13851322E-02 0.13851726E-02 0.12150000E+01 0.41535510E-02 0.13849589E-02 0.13842758E-02 0.13843162E-02 0.12152000E+01 0.41509841E-02 0.13841030E-02 0.13834204E-02 0.13834607E-02 0.12154000E+01 0.41484200E-02 0.13832480E-02 0.13825658E-02 0.13826062E-02 0.12156000E+01 0.41458587E-02 0.13823940E-02 0.13817122E-02 0.13817525E-02 0.12158000E+01 0.41433001E-02 0.13815408E-02 0.13808595E-02 0.13808998E-02 0.12160000E+01 0.41407444E-02 0.13806886E-02 0.13800077E-02 0.13800480E-02 0.12162000E+01 0.41381913E-02 0.13798373E-02 0.13791568E-02 0.13791972E-02 0.12164000E+01 0.41356411E-02 0.13789870E-02 0.13783069E-02 0.13783472E-02 0.12166000E+01 0.41330936E-02 0.13781375E-02 0.13774579E-02 0.13774982E-02 0.12168000E+01 0.41305488E-02 0.13772890E-02 0.13766098E-02 0.13766501E-02 0.12170000E+01 0.41280068E-02 0.13764414E-02 0.13757626E-02 0.13758029E-02 0.12172000E+01 0.41254675E-02 0.13755947E-02 0.13749163E-02 0.13749566E-02 0.12174000E+01 0.41229310E-02 0.13747489E-02 0.13740709E-02 0.13741112E-02 0.12176000E+01 0.41203972E-02 0.13739040E-02 0.13732265E-02 0.13732667E-02 0.12178000E+01 0.41178661E-02 0.13730600E-02 0.13723829E-02 0.13724232E-02 0.12180000E+01 0.41153378E-02 0.13722170E-02 0.13715403E-02 0.13715805E-02 0.12182000E+01 0.41128121E-02 0.13713748E-02 0.13706986E-02 0.13707388E-02 0.12184000E+01 0.41102892E-02 0.13705335E-02 0.13698577E-02 0.13698979E-02 0.12186000E+01 0.41077690E-02 0.13696932E-02 0.13690178E-02 0.13690580E-02 0.12188000E+01 0.41052515E-02 0.13688538E-02 0.13681788E-02 0.13682190E-02 0.12190000E+01 0.41027368E-02 0.13680152E-02 0.13673407E-02 0.13673809E-02 0.12192000E+01 0.41002247E-02 0.13671776E-02 0.13665035E-02 0.13665436E-02 0.12194000E+01 0.40977153E-02 0.13663408E-02 0.13656672E-02 0.13657073E-02 0.12196000E+01 0.40952086E-02 0.13655050E-02 0.13648317E-02 0.13648719E-02 0.12198000E+01 0.40927046E-02 0.13646700E-02 0.13639972E-02 0.13640373E-02 0.12200000E+01 0.40902033E-02 0.13638360E-02 0.13631636E-02 0.13632037E-02 0.12202000E+01 0.40877046E-02 0.13630028E-02 0.13623308E-02 0.13623709E-02 0.12204000E+01 0.40852086E-02 0.13621706E-02 0.13614990E-02 0.13615391E-02 0.12206000E+01 0.40827153E-02 0.13613392E-02 0.13606680E-02 0.13607081E-02 0.12208000E+01 0.40802247E-02 0.13605087E-02 0.13598380E-02 0.13598780E-02 0.12210000E+01 0.40777367E-02 0.13596791E-02 0.13590088E-02 0.13590489E-02 0.12212000E+01 0.40752514E-02 0.13588504E-02 0.13581805E-02 0.13582206E-02 0.12214000E+01 0.40727688E-02 0.13580226E-02 0.13573531E-02 0.13573931E-02 0.12216000E+01 0.40702888E-02 0.13571956E-02 0.13565266E-02 0.13565666E-02 0.12218000E+01 0.40678114E-02 0.13563696E-02 0.13557009E-02 0.13557409E-02 0.12220000E+01 0.40653367E-02 0.13555444E-02 0.13548762E-02 0.13549162E-02 0.12222000E+01 0.40628647E-02 0.13547201E-02 0.13540523E-02 0.13540923E-02 0.12224000E+01 0.40603952E-02 0.13538967E-02 0.13532293E-02 0.13532693E-02 0.12226000E+01 0.40579284E-02 0.13530741E-02 0.13524072E-02 0.13524471E-02 0.12228000E+01 0.40554643E-02 0.13522525E-02 0.13515859E-02 0.13516259E-02 0.12230000E+01 0.40530027E-02 0.13514317E-02 0.13507655E-02 0.13508055E-02 0.12232000E+01 0.40505438E-02 0.13506118E-02 0.13499460E-02 0.13499860E-02 0.12234000E+01 0.40480875E-02 0.13497927E-02 0.13491274E-02 0.13491673E-02 0.12236000E+01 0.40456338E-02 0.13489746E-02 0.13483096E-02 0.13483496E-02 0.12238000E+01 0.40431827E-02 0.13481573E-02 0.13474928E-02 0.13475327E-02 0.12240000E+01 0.40407342E-02 0.13473408E-02 0.13466767E-02 0.13467166E-02 0.12242000E+01 0.40382883E-02 0.13465253E-02 0.13458616E-02 0.13459015E-02 0.12244000E+01 0.40358450E-02 0.13457106E-02 0.13450473E-02 0.13450872E-02 0.12246000E+01 0.40334043E-02 0.13448967E-02 0.13442339E-02 0.13442737E-02 0.12248000E+01 0.40309662E-02 0.13440837E-02 0.13434213E-02 0.13434612E-02 0.12250000E+01 0.40285307E-02 0.13432716E-02 0.13426096E-02 0.13426495E-02 0.12252000E+01 0.40260978E-02 0.13424604E-02 0.13417988E-02 0.13418386E-02 0.12254000E+01 0.40236674E-02 0.13416500E-02 0.13409888E-02 0.13410286E-02 0.12256000E+01 0.40212396E-02 0.13408405E-02 0.13401797E-02 0.13402195E-02 0.12258000E+01 0.40188144E-02 0.13400318E-02 0.13393714E-02 0.13394112E-02 0.12260000E+01 0.40163917E-02 0.13392240E-02 0.13385640E-02 0.13386038E-02 0.12262000E+01 0.40139716E-02 0.13384170E-02 0.13377574E-02 0.13377972E-02 0.12264000E+01 0.40115541E-02 0.13376109E-02 0.13369517E-02 0.13369915E-02 0.12266000E+01 0.40091391E-02 0.13368056E-02 0.13361469E-02 0.13361866E-02 0.12268000E+01 0.40067267E-02 0.13360012E-02 0.13353429E-02 0.13353826E-02 0.12270000E+01 0.40043168E-02 0.13351977E-02 0.13345397E-02 0.13345795E-02 0.12272000E+01 0.40019095E-02 0.13343949E-02 0.13337374E-02 0.13337771E-02 0.12274000E+01 0.39995047E-02 0.13335931E-02 0.13329359E-02 0.13329757E-02 0.12276000E+01 0.39971024E-02 0.13327921E-02 0.13321353E-02 0.13321750E-02 0.12278000E+01 0.39947027E-02 0.13319919E-02 0.13313355E-02 0.13313753E-02 0.12280000E+01 0.39923055E-02 0.13311925E-02 0.13305366E-02 0.13305763E-02 0.12282000E+01 0.39899108E-02 0.13303941E-02 0.13297385E-02 0.13297782E-02 0.12284000E+01 0.39875186E-02 0.13295964E-02 0.13289413E-02 0.13289810E-02 0.12286000E+01 0.39851290E-02 0.13287996E-02 0.13281449E-02 0.13281845E-02 0.12288000E+01 0.39827419E-02 0.13280036E-02 0.13273493E-02 0.13273890E-02 0.12290000E+01 0.39803573E-02 0.13272085E-02 0.13265546E-02 0.13265942E-02 0.12292000E+01 0.39779751E-02 0.13264142E-02 0.13257607E-02 0.13258003E-02 0.12294000E+01 0.39755955E-02 0.13256207E-02 0.13249676E-02 0.13250072E-02 0.12296000E+01 0.39732184E-02 0.13248281E-02 0.13241754E-02 0.13242150E-02 0.12298000E+01 0.39708438E-02 0.13240363E-02 0.13233840E-02 0.13234236E-02 0.12300000E+01 0.39684717E-02 0.13232453E-02 0.13225934E-02 0.13226330E-02 0.12302000E+01 0.39661020E-02 0.13224552E-02 0.13218036E-02 0.13218432E-02 0.12304000E+01 0.39637349E-02 0.13216658E-02 0.13210147E-02 0.13210543E-02 0.12306000E+01 0.39613702E-02 0.13208774E-02 0.13202266E-02 0.13202662E-02 0.12308000E+01 0.39590080E-02 0.13200897E-02 0.13194394E-02 0.13194789E-02 0.12310000E+01 0.39566483E-02 0.13193029E-02 0.13186529E-02 0.13186925E-02 0.12312000E+01 0.39542910E-02 0.13185169E-02 0.13178673E-02 0.13179069E-02 0.12314000E+01 0.39519362E-02 0.13177317E-02 0.13170825E-02 0.13171221E-02 0.12316000E+01 0.39495839E-02 0.13169473E-02 0.13162985E-02 0.13163381E-02 0.12318000E+01 0.39472340E-02 0.13161637E-02 0.13155154E-02 0.13155549E-02 0.12320000E+01 0.39448866E-02 0.13153810E-02 0.13147330E-02 0.13147726E-02 0.12322000E+01 0.39425416E-02 0.13145991E-02 0.13139515E-02 0.13139910E-02 0.12324000E+01 0.39401991E-02 0.13138180E-02 0.13131708E-02 0.13132103E-02 0.12326000E+01 0.39378591E-02 0.13130377E-02 0.13123909E-02 0.13124304E-02 0.12328000E+01 0.39355214E-02 0.13122582E-02 0.13116119E-02 0.13116513E-02 0.12330000E+01 0.39331862E-02 0.13114796E-02 0.13108336E-02 0.13108731E-02 0.12332000E+01 0.39308535E-02 0.13107017E-02 0.13100561E-02 0.13100956E-02 0.12334000E+01 0.39285231E-02 0.13099247E-02 0.13092795E-02 0.13093189E-02 0.12336000E+01 0.39261952E-02 0.13091485E-02 0.13085037E-02 0.13085431E-02 0.12338000E+01 0.39238697E-02 0.13083731E-02 0.13077286E-02 0.13077680E-02 0.12340000E+01 0.39215467E-02 0.13075984E-02 0.13069544E-02 0.13069938E-02 0.12342000E+01 0.39192260E-02 0.13068246E-02 0.13061810E-02 0.13062204E-02 0.12344000E+01 0.39169078E-02 0.13060516E-02 0.13054084E-02 0.13054478E-02 0.12346000E+01 0.39145919E-02 0.13052794E-02 0.13046366E-02 0.13046759E-02 0.12348000E+01 0.39122785E-02 0.13045080E-02 0.13038656E-02 0.13039049E-02 0.12350000E+01 0.39099675E-02 0.13037374E-02 0.13030953E-02 0.13031347E-02 0.12352000E+01 0.39076588E-02 0.13029676E-02 0.13023259E-02 0.13023653E-02 0.12354000E+01 0.39053526E-02 0.13021986E-02 0.13015573E-02 0.13015967E-02 0.12356000E+01 0.39030488E-02 0.13014304E-02 0.13007895E-02 0.13008288E-02 0.12358000E+01 0.39007473E-02 0.13006630E-02 0.13000225E-02 0.13000618E-02 0.12360000E+01 0.38984482E-02 0.12998964E-02 0.12992563E-02 0.12992956E-02 0.12362000E+01 0.38961515E-02 0.12991306E-02 0.12984908E-02 0.12985301E-02 0.12364000E+01 0.38938572E-02 0.12983656E-02 0.12977262E-02 0.12977655E-02 0.12366000E+01 0.38915653E-02 0.12976013E-02 0.12969623E-02 0.12970016E-02 0.12368000E+01 0.38892757E-02 0.12968379E-02 0.12961993E-02 0.12962385E-02 0.12370000E+01 0.38869885E-02 0.12960752E-02 0.12954370E-02 0.12954763E-02 0.12372000E+01 0.38847037E-02 0.12953134E-02 0.12946755E-02 0.12947148E-02 0.12374000E+01 0.38824212E-02 0.12945523E-02 0.12939148E-02 0.12939541E-02 0.12376000E+01 0.38801411E-02 0.12937920E-02 0.12931549E-02 0.12931941E-02 0.12378000E+01 0.38778633E-02 0.12930325E-02 0.12923958E-02 0.12924350E-02 0.12380000E+01 0.38755879E-02 0.12922738E-02 0.12916374E-02 0.12916767E-02 0.12382000E+01 0.38733148E-02 0.12915158E-02 0.12908799E-02 0.12909191E-02 0.12384000E+01 0.38710440E-02 0.12907586E-02 0.12901231E-02 0.12901623E-02 0.12386000E+01 0.38687756E-02 0.12900023E-02 0.12893671E-02 0.12894063E-02 0.12388000E+01 0.38665096E-02 0.12892467E-02 0.12886119E-02 0.12886510E-02 0.12390000E+01 0.38642458E-02 0.12884918E-02 0.12878574E-02 0.12878966E-02 0.12392000E+01 0.38619844E-02 0.12877378E-02 0.12871038E-02 0.12871429E-02 0.12394000E+01 0.38597254E-02 0.12869845E-02 0.12863509E-02 0.12863900E-02 0.12396000E+01 0.38574686E-02 0.12862320E-02 0.12855987E-02 0.12856379E-02 0.12398000E+01 0.38552142E-02 0.12854803E-02 0.12848474E-02 0.12848865E-02 0.12400000E+01 0.38529621E-02 0.12847293E-02 0.12840968E-02 0.12841359E-02 0.12402000E+01 0.38507123E-02 0.12839791E-02 0.12833470E-02 0.12833861E-02 0.12404000E+01 0.38484648E-02 0.12832297E-02 0.12825980E-02 0.12826371E-02 0.12406000E+01 0.38462196E-02 0.12824811E-02 0.12818497E-02 0.12818888E-02 0.12408000E+01 0.38439767E-02 0.12817332E-02 0.12811022E-02 0.12811413E-02 0.12410000E+01 0.38417361E-02 0.12809861E-02 0.12803555E-02 0.12803945E-02 0.12412000E+01 0.38394978E-02 0.12802397E-02 0.12796095E-02 0.12796486E-02 0.12414000E+01 0.38372618E-02 0.12794942E-02 0.12788643E-02 0.12789033E-02 0.12416000E+01 0.38350281E-02 0.12787493E-02 0.12781199E-02 0.12781589E-02 0.12418000E+01 0.38327967E-02 0.12780053E-02 0.12773762E-02 0.12774152E-02 0.12420000E+01 0.38305675E-02 0.12772620E-02 0.12766333E-02 0.12766723E-02 0.12422000E+01 0.38283407E-02 0.12765195E-02 0.12758911E-02 0.12759301E-02 0.12424000E+01 0.38261161E-02 0.12757777E-02 0.12751497E-02 0.12751887E-02 0.12426000E+01 0.38238937E-02 0.12750367E-02 0.12744091E-02 0.12744480E-02 0.12428000E+01 0.38216737E-02 0.12742964E-02 0.12736692E-02 0.12737081E-02 0.12430000E+01 0.38194559E-02 0.12735569E-02 0.12729300E-02 0.12729690E-02 0.12432000E+01 0.38172404E-02 0.12728182E-02 0.12721917E-02 0.12722306E-02 0.12434000E+01 0.38150271E-02 0.12720802E-02 0.12714540E-02 0.12714930E-02 0.12436000E+01 0.38128161E-02 0.12713429E-02 0.12707172E-02 0.12707561E-02 0.12438000E+01 0.38106074E-02 0.12706064E-02 0.12699810E-02 0.12700199E-02 0.12440000E+01 0.38084009E-02 0.12698707E-02 0.12692457E-02 0.12692846E-02 0.12442000E+01 0.38061966E-02 0.12691357E-02 0.12685110E-02 0.12685499E-02 0.12444000E+01 0.38039946E-02 0.12684014E-02 0.12677772E-02 0.12678160E-02 0.12446000E+01 0.38017949E-02 0.12676679E-02 0.12670440E-02 0.12670829E-02 0.12448000E+01 0.37995973E-02 0.12669352E-02 0.12663116E-02 0.12663505E-02 0.12450000E+01 0.37974020E-02 0.12662032E-02 0.12655800E-02 0.12656189E-02 0.12452000E+01 0.37952090E-02 0.12654719E-02 0.12648491E-02 0.12648879E-02 0.12454000E+01 0.37930181E-02 0.12647414E-02 0.12641190E-02 0.12641578E-02 0.12456000E+01 0.37908295E-02 0.12640116E-02 0.12633895E-02 0.12634284E-02 0.12458000E+01 0.37886431E-02 0.12632826E-02 0.12626609E-02 0.12626997E-02 0.12460000E+01 0.37864589E-02 0.12625543E-02 0.12619329E-02 0.12619717E-02 0.12462000E+01 0.37842770E-02 0.12618267E-02 0.12612057E-02 0.12612445E-02 0.12464000E+01 0.37820972E-02 0.12610999E-02 0.12604793E-02 0.12605181E-02 0.12466000E+01 0.37799197E-02 0.12603738E-02 0.12597536E-02 0.12597923E-02 0.12468000E+01 0.37777443E-02 0.12596484E-02 0.12590286E-02 0.12590673E-02 0.12470000E+01 0.37755712E-02 0.12589238E-02 0.12583043E-02 0.12583431E-02 0.12472000E+01 0.37734003E-02 0.12581999E-02 0.12575808E-02 0.12576195E-02 0.12474000E+01 0.37712315E-02 0.12574768E-02 0.12568580E-02 0.12568967E-02 0.12476000E+01 0.37690650E-02 0.12567544E-02 0.12561360E-02 0.12561747E-02 0.12478000E+01 0.37669006E-02 0.12560327E-02 0.12554146E-02 0.12554533E-02 0.12480000E+01 0.37647384E-02 0.12553117E-02 0.12546940E-02 0.12547327E-02 0.12482000E+01 0.37625785E-02 0.12545915E-02 0.12539742E-02 0.12540128E-02 0.12484000E+01 0.37604206E-02 0.12538720E-02 0.12532550E-02 0.12532937E-02 0.12486000E+01 0.37582650E-02 0.12531532E-02 0.12525366E-02 0.12525753E-02 0.12488000E+01 0.37561116E-02 0.12524351E-02 0.12518189E-02 0.12518575E-02 0.12490000E+01 0.37539603E-02 0.12517178E-02 0.12511019E-02 0.12511406E-02 0.12492000E+01 0.37518112E-02 0.12510012E-02 0.12503857E-02 0.12504243E-02 0.12494000E+01 0.37496642E-02 0.12502853E-02 0.12496701E-02 0.12497088E-02 0.12496000E+01 0.37475194E-02 0.12495701E-02 0.12489553E-02 0.12489940E-02 0.12498000E+01 0.37453768E-02 0.12488557E-02 0.12482413E-02 0.12482799E-02 0.12500000E+01 0.37432363E-02 0.12481419E-02 0.12475279E-02 0.12475665E-02 0.12502000E+01 0.37410980E-02 0.12474289E-02 0.12468152E-02 0.12468538E-02 0.12504000E+01 0.37389618E-02 0.12467166E-02 0.12461033E-02 0.12461419E-02 0.12506000E+01 0.37368278E-02 0.12460051E-02 0.12453921E-02 0.12454306E-02 0.12508000E+01 0.37346959E-02 0.12452942E-02 0.12446816E-02 0.12447201E-02 0.12510000E+01 0.37325662E-02 0.12445841E-02 0.12439718E-02 0.12440103E-02 0.12512000E+01 0.37304385E-02 0.12438746E-02 0.12432627E-02 0.12433012E-02 0.12514000E+01 0.37283131E-02 0.12431659E-02 0.12425543E-02 0.12425929E-02 0.12516000E+01 0.37261897E-02 0.12424579E-02 0.12418467E-02 0.12418852E-02 0.12518000E+01 0.37240685E-02 0.12417506E-02 0.12411397E-02 0.12411782E-02 0.12520000E+01 0.37219494E-02 0.12410440E-02 0.12404335E-02 0.12404720E-02 0.12522000E+01 0.37198325E-02 0.12403381E-02 0.12397280E-02 0.12397664E-02 0.12524000E+01 0.37177176E-02 0.12396329E-02 0.12390231E-02 0.12390616E-02 0.12526000E+01 0.37156049E-02 0.12389284E-02 0.12383190E-02 0.12383575E-02 0.12528000E+01 0.37134943E-02 0.12382247E-02 0.12376156E-02 0.12376540E-02 0.12530000E+01 0.37113858E-02 0.12375216E-02 0.12369129E-02 0.12369513E-02 0.12532000E+01 0.37092794E-02 0.12368192E-02 0.12362109E-02 0.12362493E-02 0.12534000E+01 0.37071751E-02 0.12361176E-02 0.12355096E-02 0.12355480E-02 0.12536000E+01 0.37050729E-02 0.12354166E-02 0.12348089E-02 0.12348474E-02 0.12538000E+01 0.37029728E-02 0.12347163E-02 0.12341090E-02 0.12341474E-02 0.12540000E+01 0.37008748E-02 0.12340168E-02 0.12334098E-02 0.12334482E-02 0.12542000E+01 0.36987789E-02 0.12333179E-02 0.12327113E-02 0.12327497E-02 0.12544000E+01 0.36966851E-02 0.12326197E-02 0.12320135E-02 0.12320519E-02 0.12546000E+01 0.36945934E-02 0.12319223E-02 0.12313164E-02 0.12313547E-02 0.12548000E+01 0.36925037E-02 0.12312255E-02 0.12306200E-02 0.12306583E-02 0.12550000E+01 0.36904162E-02 0.12305294E-02 0.12299242E-02 0.12299626E-02 0.12552000E+01 0.36883307E-02 0.12298340E-02 0.12292292E-02 0.12292675E-02 0.12554000E+01 0.36862473E-02 0.12291393E-02 0.12285348E-02 0.12285731E-02 0.12556000E+01 0.36841660E-02 0.12284453E-02 0.12278412E-02 0.12278795E-02 0.12558000E+01 0.36820867E-02 0.12277520E-02 0.12271482E-02 0.12271865E-02 0.12560000E+01 0.36800095E-02 0.12270594E-02 0.12264559E-02 0.12264942E-02 0.12562000E+01 0.36779344E-02 0.12263674E-02 0.12257643E-02 0.12258026E-02 0.12564000E+01 0.36758613E-02 0.12256762E-02 0.12250734E-02 0.12251117E-02 0.12566000E+01 0.36737903E-02 0.12249856E-02 0.12243832E-02 0.12244215E-02 0.12568000E+01 0.36717213E-02 0.12242957E-02 0.12236937E-02 0.12237319E-02 0.12570000E+01 0.36696544E-02 0.12236065E-02 0.12230048E-02 0.12230431E-02 0.12572000E+01 0.36675895E-02 0.12229180E-02 0.12223167E-02 0.12223549E-02 0.12574000E+01 0.36655267E-02 0.12222302E-02 0.12216292E-02 0.12216674E-02 0.12576000E+01 0.36634660E-02 0.12215430E-02 0.12209424E-02 0.12209806E-02 0.12578000E+01 0.36614072E-02 0.12208566E-02 0.12202562E-02 0.12202944E-02 0.12580000E+01 0.36593505E-02 0.12201708E-02 0.12195708E-02 0.12196090E-02 0.12582000E+01 0.36572959E-02 0.12194857E-02 0.12188860E-02 0.12189242E-02 0.12584000E+01 0.36552433E-02 0.12188012E-02 0.12182019E-02 0.12182401E-02 0.12586000E+01 0.36531927E-02 0.12181175E-02 0.12175185E-02 0.12175567E-02 0.12588000E+01 0.36511441E-02 0.12174344E-02 0.12168358E-02 0.12168739E-02 0.12590000E+01 0.36490976E-02 0.12167520E-02 0.12161537E-02 0.12161918E-02 0.12592000E+01 0.36470530E-02 0.12160702E-02 0.12154723E-02 0.12155104E-02 0.12594000E+01 0.36450105E-02 0.12153892E-02 0.12147916E-02 0.12148297E-02 0.12596000E+01 0.36429700E-02 0.12147088E-02 0.12141116E-02 0.12141497E-02 0.12598000E+01 0.36409316E-02 0.12140291E-02 0.12134322E-02 0.12134703E-02 0.12600000E+01 0.36388951E-02 0.12133500E-02 0.12127535E-02 0.12127916E-02 0.12602000E+01 0.36368606E-02 0.12126717E-02 0.12120755E-02 0.12121135E-02 0.12604000E+01 0.36348282E-02 0.12119939E-02 0.12113981E-02 0.12114361E-02 0.12606000E+01 0.36327977E-02 0.12113169E-02 0.12107214E-02 0.12107594E-02 0.12608000E+01 0.36307693E-02 0.12106405E-02 0.12100453E-02 0.12100834E-02 0.12610000E+01 0.36287428E-02 0.12099648E-02 0.12093700E-02 0.12094080E-02 0.12612000E+01 0.36267183E-02 0.12092898E-02 0.12086953E-02 0.12087333E-02 0.12614000E+01 0.36246959E-02 0.12086154E-02 0.12080212E-02 0.12080592E-02 0.12616000E+01 0.36226754E-02 0.12079417E-02 0.12073478E-02 0.12073858E-02 0.12618000E+01 0.36206569E-02 0.12072686E-02 0.12066751E-02 0.12067131E-02 0.12620000E+01 0.36186403E-02 0.12065962E-02 0.12060031E-02 0.12060410E-02 0.12622000E+01 0.36166258E-02 0.12059245E-02 0.12053317E-02 0.12053696E-02 0.12624000E+01 0.36146132E-02 0.12052534E-02 0.12046609E-02 0.12046989E-02 0.12626000E+01 0.36126026E-02 0.12045830E-02 0.12039909E-02 0.12040288E-02 0.12628000E+01 0.36105940E-02 0.12039132E-02 0.12033214E-02 0.12033594E-02 0.12630000E+01 0.36085874E-02 0.12032441E-02 0.12026527E-02 0.12026906E-02 0.12632000E+01 0.36065827E-02 0.12025757E-02 0.12019845E-02 0.12020225E-02 0.12634000E+01 0.36045800E-02 0.12019079E-02 0.12013171E-02 0.12013550E-02 0.12636000E+01 0.36025792E-02 0.12012407E-02 0.12006503E-02 0.12006882E-02 0.12638000E+01 0.36005804E-02 0.12005742E-02 0.11999841E-02 0.12000220E-02 0.12640000E+01 0.35985835E-02 0.11999084E-02 0.11993186E-02 0.11993565E-02 0.12642000E+01 0.35965886E-02 0.11992432E-02 0.11986538E-02 0.11986916E-02 0.12644000E+01 0.35945957E-02 0.11985787E-02 0.11979896E-02 0.11980274E-02 0.12646000E+01 0.35926047E-02 0.11979148E-02 0.11973260E-02 0.11973639E-02 0.12648000E+01 0.35906156E-02 0.11972516E-02 0.11966631E-02 0.11967009E-02 0.12650000E+01 0.35886285E-02 0.11965890E-02 0.11960009E-02 0.11960387E-02 0.12652000E+01 0.35866433E-02 0.11959270E-02 0.11953392E-02 0.11953771E-02 0.12654000E+01 0.35846601E-02 0.11952657E-02 0.11946783E-02 0.11947161E-02 0.12656000E+01 0.35826788E-02 0.11946051E-02 0.11940180E-02 0.11940557E-02 0.12658000E+01 0.35806994E-02 0.11939451E-02 0.11933583E-02 0.11933961E-02 0.12660000E+01 0.35787220E-02 0.11932857E-02 0.11926992E-02 0.11927370E-02 0.12662000E+01 0.35767464E-02 0.11926270E-02 0.11920409E-02 0.11920786E-02 0.12664000E+01 0.35747728E-02 0.11919689E-02 0.11913831E-02 0.11914208E-02 0.12666000E+01 0.35728012E-02 0.11913114E-02 0.11907260E-02 0.11907637E-02 0.12668000E+01 0.35708314E-02 0.11906546E-02 0.11900695E-02 0.11901072E-02 0.12670000E+01 0.35688635E-02 0.11899985E-02 0.11894137E-02 0.11894514E-02 0.12672000E+01 0.35668976E-02 0.11893429E-02 0.11887585E-02 0.11887962E-02 0.12674000E+01 0.35649336E-02 0.11886881E-02 0.11881039E-02 0.11881416E-02 0.12676000E+01 0.35629715E-02 0.11880338E-02 0.11874500E-02 0.11874877E-02 0.12678000E+01 0.35610113E-02 0.11873802E-02 0.11867967E-02 0.11868344E-02 0.12680000E+01 0.35590529E-02 0.11867272E-02 0.11861440E-02 0.11861817E-02 0.12682000E+01 0.35570965E-02 0.11860748E-02 0.11854920E-02 0.11855297E-02 0.12684000E+01 0.35551420E-02 0.11854231E-02 0.11848406E-02 0.11848783E-02 0.12686000E+01 0.35531894E-02 0.11847720E-02 0.11841899E-02 0.11842275E-02 0.12688000E+01 0.35512387E-02 0.11841216E-02 0.11835397E-02 0.11835774E-02 0.12690000E+01 0.35492898E-02 0.11834717E-02 0.11828902E-02 0.11829278E-02 0.12692000E+01 0.35473429E-02 0.11828226E-02 0.11822414E-02 0.11822790E-02 0.12694000E+01 0.35453978E-02 0.11821740E-02 0.11815931E-02 0.11816307E-02 0.12696000E+01 0.35434546E-02 0.11815260E-02 0.11809455E-02 0.11809831E-02 0.12698000E+01 0.35415133E-02 0.11808787E-02 0.11802985E-02 0.11803361E-02 0.12700000E+01 0.35395739E-02 0.11802320E-02 0.11796521E-02 0.11796897E-02 0.12702000E+01 0.35376363E-02 0.11795860E-02 0.11790064E-02 0.11790440E-02 0.12704000E+01 0.35357006E-02 0.11789405E-02 0.11783613E-02 0.11783988E-02 0.12706000E+01 0.35337668E-02 0.11782957E-02 0.11777168E-02 0.11777543E-02 0.12708000E+01 0.35318348E-02 0.11776515E-02 0.11770729E-02 0.11771104E-02 0.12710000E+01 0.35299048E-02 0.11770079E-02 0.11764297E-02 0.11764672E-02 0.12712000E+01 0.35279765E-02 0.11763650E-02 0.11757870E-02 0.11758245E-02 0.12714000E+01 0.35260502E-02 0.11757226E-02 0.11751450E-02 0.11751825E-02 0.12716000E+01 0.35241256E-02 0.11750809E-02 0.11745036E-02 0.11745411E-02 0.12718000E+01 0.35222030E-02 0.11744398E-02 0.11738628E-02 0.11739003E-02 0.12720000E+01 0.35202822E-02 0.11737993E-02 0.11732227E-02 0.11732601E-02 0.12722000E+01 0.35183632E-02 0.11731595E-02 0.11725831E-02 0.11726206E-02 0.12724000E+01 0.35164461E-02 0.11725202E-02 0.11719442E-02 0.11719817E-02 0.12726000E+01 0.35145308E-02 0.11718816E-02 0.11713059E-02 0.11713433E-02 0.12728000E+01 0.35126174E-02 0.11712436E-02 0.11706682E-02 0.11707056E-02 0.12730000E+01 0.35107058E-02 0.11706062E-02 0.11700311E-02 0.11700685E-02 0.12732000E+01 0.35087960E-02 0.11699694E-02 0.11693946E-02 0.11694320E-02 0.12734000E+01 0.35068881E-02 0.11693332E-02 0.11687588E-02 0.11687962E-02 0.12736000E+01 0.35049820E-02 0.11686976E-02 0.11681235E-02 0.11681609E-02 0.12738000E+01 0.35030778E-02 0.11680626E-02 0.11674889E-02 0.11675262E-02 0.12740000E+01 0.35011753E-02 0.11674283E-02 0.11668548E-02 0.11668922E-02 0.12742000E+01 0.34992747E-02 0.11667945E-02 0.11662214E-02 0.11662588E-02 0.12744000E+01 0.34973759E-02 0.11661614E-02 0.11655886E-02 0.11656259E-02 0.12746000E+01 0.34954789E-02 0.11655289E-02 0.11649564E-02 0.11649937E-02 0.12748000E+01 0.34935838E-02 0.11648969E-02 0.11643248E-02 0.11643621E-02 0.12750000E+01 0.34916904E-02 0.11642656E-02 0.11636938E-02 0.11637311E-02 0.12752000E+01 0.34897989E-02 0.11636349E-02 0.11630634E-02 0.11631006E-02 0.12754000E+01 0.34879092E-02 0.11630048E-02 0.11624336E-02 0.11624708E-02 0.12756000E+01 0.34860213E-02 0.11623753E-02 0.11618044E-02 0.11618416E-02 0.12758000E+01 0.34841351E-02 0.11617464E-02 0.11611758E-02 0.11612130E-02 0.12760000E+01 0.34822508E-02 0.11611180E-02 0.11605478E-02 0.11605850E-02 0.12762000E+01 0.34803683E-02 0.11604903E-02 0.11599204E-02 0.11599576E-02 0.12764000E+01 0.34784876E-02 0.11598632E-02 0.11592936E-02 0.11593308E-02 0.12766000E+01 0.34766087E-02 0.11592367E-02 0.11586674E-02 0.11587046E-02 0.12768000E+01 0.34747315E-02 0.11586108E-02 0.11580418E-02 0.11580790E-02 0.12770000E+01 0.34728562E-02 0.11579855E-02 0.11574168E-02 0.11574540E-02 0.12772000E+01 0.34709826E-02 0.11573607E-02 0.11567924E-02 0.11568295E-02 0.12774000E+01 0.34691109E-02 0.11567366E-02 0.11561685E-02 0.11562057E-02 0.12776000E+01 0.34672409E-02 0.11561131E-02 0.11555453E-02 0.11555825E-02 0.12778000E+01 0.34653727E-02 0.11554901E-02 0.11549227E-02 0.11549599E-02 0.12780000E+01 0.34635062E-02 0.11548678E-02 0.11543007E-02 0.11543378E-02 0.12782000E+01 0.34616416E-02 0.11542460E-02 0.11536792E-02 0.11537164E-02 0.12784000E+01 0.34597787E-02 0.11536249E-02 0.11530584E-02 0.11530955E-02 0.12786000E+01 0.34579176E-02 0.11530043E-02 0.11524381E-02 0.11524752E-02 0.12788000E+01 0.34560583E-02 0.11523843E-02 0.11518184E-02 0.11518555E-02 0.12790000E+01 0.34542007E-02 0.11517649E-02 0.11511993E-02 0.11512364E-02 0.12792000E+01 0.34523449E-02 0.11511461E-02 0.11505808E-02 0.11506179E-02 0.12794000E+01 0.34504908E-02 0.11505279E-02 0.11499629E-02 0.11500000E-02 0.12796000E+01 0.34486385E-02 0.11499102E-02 0.11493456E-02 0.11493827E-02 0.12798000E+01 0.34467880E-02 0.11492932E-02 0.11487289E-02 0.11487659E-02 0.12800000E+01 0.34449392E-02 0.11486767E-02 0.11481127E-02 0.11481498E-02 0.12802000E+01 0.34430922E-02 0.11480609E-02 0.11474971E-02 0.11475342E-02 0.12804000E+01 0.34412469E-02 0.11474456E-02 0.11468821E-02 0.11469192E-02 0.12806000E+01 0.34394033E-02 0.11468308E-02 0.11462677E-02 0.11463048E-02 0.12808000E+01 0.34375615E-02 0.11462167E-02 0.11456539E-02 0.11456909E-02 0.12810000E+01 0.34357215E-02 0.11456032E-02 0.11450407E-02 0.11450777E-02 0.12812000E+01 0.34338832E-02 0.11449902E-02 0.11444280E-02 0.11444650E-02 0.12814000E+01 0.34320466E-02 0.11443778E-02 0.11438159E-02 0.11438529E-02 0.12816000E+01 0.34302118E-02 0.11437660E-02 0.11432044E-02 0.11432414E-02 0.12818000E+01 0.34283787E-02 0.11431547E-02 0.11425935E-02 0.11426304E-02 0.12820000E+01 0.34265473E-02 0.11425441E-02 0.11419831E-02 0.11420201E-02 0.12822000E+01 0.34247177E-02 0.11419340E-02 0.11413734E-02 0.11414103E-02 0.12824000E+01 0.34228897E-02 0.11413245E-02 0.11407642E-02 0.11408011E-02 0.12826000E+01 0.34210635E-02 0.11407156E-02 0.11401555E-02 0.11401924E-02 0.12828000E+01 0.34192391E-02 0.11401072E-02 0.11395475E-02 0.11395844E-02 0.12830000E+01 0.34174163E-02 0.11394994E-02 0.11389400E-02 0.11389769E-02 0.12832000E+01 0.34155953E-02 0.11388922E-02 0.11383331E-02 0.11383700E-02 0.12834000E+01 0.34137759E-02 0.11382856E-02 0.11377268E-02 0.11377636E-02 0.12836000E+01 0.34119583E-02 0.11376795E-02 0.11371210E-02 0.11371579E-02 0.12838000E+01 0.34101424E-02 0.11370740E-02 0.11365158E-02 0.11365527E-02 0.12840000E+01 0.34083282E-02 0.11364691E-02 0.11359112E-02 0.11359480E-02 0.12842000E+01 0.34065158E-02 0.11358647E-02 0.11353071E-02 0.11353439E-02 0.12844000E+01 0.34047050E-02 0.11352609E-02 0.11347036E-02 0.11347404E-02 0.12846000E+01 0.34028959E-02 0.11346577E-02 0.11341007E-02 0.11341375E-02 0.12848000E+01 0.34010885E-02 0.11340550E-02 0.11334983E-02 0.11335351E-02 0.12850000E+01 0.33992828E-02 0.11334529E-02 0.11328965E-02 0.11329333E-02 0.12852000E+01 0.33974788E-02 0.11328514E-02 0.11322953E-02 0.11323321E-02 0.12854000E+01 0.33956765E-02 0.11322504E-02 0.11316947E-02 0.11317314E-02 0.12856000E+01 0.33938759E-02 0.11316500E-02 0.11310946E-02 0.11311313E-02 0.12858000E+01 0.33920770E-02 0.11310502E-02 0.11304950E-02 0.11305318E-02 0.12860000E+01 0.33902798E-02 0.11304509E-02 0.11298960E-02 0.11299328E-02 0.12862000E+01 0.33884842E-02 0.11298522E-02 0.11292976E-02 0.11293344E-02 0.12864000E+01 0.33866903E-02 0.11292540E-02 0.11286998E-02 0.11287365E-02 0.12866000E+01 0.33848981E-02 0.11286565E-02 0.11281025E-02 0.11281392E-02 0.12868000E+01 0.33831076E-02 0.11280594E-02 0.11275057E-02 0.11275424E-02 0.12870000E+01 0.33813188E-02 0.11274629E-02 0.11269096E-02 0.11269463E-02 0.12872000E+01 0.33795316E-02 0.11268670E-02 0.11263139E-02 0.11263506E-02 0.12874000E+01 0.33777461E-02 0.11262717E-02 0.11257189E-02 0.11257556E-02 0.12876000E+01 0.33759623E-02 0.11256768E-02 0.11251244E-02 0.11251610E-02 0.12878000E+01 0.33741801E-02 0.11250826E-02 0.11245304E-02 0.11245671E-02 0.12880000E+01 0.33723996E-02 0.11244889E-02 0.11239370E-02 0.11239737E-02 0.12882000E+01 0.33706207E-02 0.11238958E-02 0.11233442E-02 0.11233808E-02 0.12884000E+01 0.33688436E-02 0.11233032E-02 0.11227519E-02 0.11227885E-02 0.12886000E+01 0.33670680E-02 0.11227111E-02 0.11221601E-02 0.11221968E-02 0.12888000E+01 0.33652942E-02 0.11221196E-02 0.11215690E-02 0.11216056E-02 0.12890000E+01 0.33635219E-02 0.11215287E-02 0.11209783E-02 0.11210149E-02 0.12892000E+01 0.33617514E-02 0.11209383E-02 0.11203882E-02 0.11204248E-02 0.12894000E+01 0.33599824E-02 0.11203485E-02 0.11197987E-02 0.11198353E-02 0.12896000E+01 0.33582152E-02 0.11197592E-02 0.11192097E-02 0.11192463E-02 0.12898000E+01 0.33564495E-02 0.11191705E-02 0.11186213E-02 0.11186578E-02 0.12900000E+01 0.33546855E-02 0.11185823E-02 0.11180334E-02 0.11180699E-02 0.12902000E+01 0.33529232E-02 0.11179946E-02 0.11174460E-02 0.11174825E-02 0.12904000E+01 0.33511625E-02 0.11174075E-02 0.11168592E-02 0.11168957E-02 0.12906000E+01 0.33494034E-02 0.11168210E-02 0.11162729E-02 0.11163095E-02 0.12908000E+01 0.33476459E-02 0.11162350E-02 0.11156872E-02 0.11157237E-02 0.12910000E+01 0.33458901E-02 0.11156495E-02 0.11151021E-02 0.11151386E-02 0.12912000E+01 0.33441359E-02 0.11150646E-02 0.11145174E-02 0.11145539E-02 0.12914000E+01 0.33423834E-02 0.11144802E-02 0.11139333E-02 0.11139698E-02 0.12916000E+01 0.33406324E-02 0.11138964E-02 0.11133498E-02 0.11133863E-02 0.12918000E+01 0.33388831E-02 0.11133131E-02 0.11127668E-02 0.11128033E-02 0.12920000E+01 0.33371354E-02 0.11127303E-02 0.11121843E-02 0.11122208E-02 0.12922000E+01 0.33353894E-02 0.11121481E-02 0.11116024E-02 0.11116388E-02 0.12924000E+01 0.33336449E-02 0.11115664E-02 0.11110210E-02 0.11110575E-02 0.12926000E+01 0.33319021E-02 0.11109853E-02 0.11104402E-02 0.11104766E-02 0.12928000E+01 0.33301608E-02 0.11104047E-02 0.11098599E-02 0.11098963E-02 0.12930000E+01 0.33284212E-02 0.11098246E-02 0.11092801E-02 0.11093165E-02 0.12932000E+01 0.33266832E-02 0.11092451E-02 0.11087009E-02 0.11087372E-02 0.12934000E+01 0.33249468E-02 0.11086661E-02 0.11081222E-02 0.11081585E-02 0.12936000E+01 0.33232120E-02 0.11080876E-02 0.11075440E-02 0.11075803E-02 0.12938000E+01 0.33214788E-02 0.11075097E-02 0.11069664E-02 0.11070027E-02 0.12940000E+01 0.33197472E-02 0.11069323E-02 0.11063892E-02 0.11064256E-02 0.12942000E+01 0.33180171E-02 0.11063555E-02 0.11058127E-02 0.11058490E-02 0.12944000E+01 0.33162887E-02 0.11057791E-02 0.11052366E-02 0.11052730E-02 0.12946000E+01 0.33145619E-02 0.11052033E-02 0.11046611E-02 0.11046974E-02 0.12948000E+01 0.33128367E-02 0.11046281E-02 0.11040862E-02 0.11041225E-02 0.12950000E+01 0.33111130E-02 0.11040533E-02 0.11035117E-02 0.11035480E-02 0.12952000E+01 0.33093910E-02 0.11034791E-02 0.11029378E-02 0.11029741E-02 0.12954000E+01 0.33076705E-02 0.11029054E-02 0.11023644E-02 0.11024007E-02 0.12956000E+01 0.33059516E-02 0.11023323E-02 0.11017915E-02 0.11018278E-02 0.12958000E+01 0.33042343E-02 0.11017597E-02 0.11012192E-02 0.11012555E-02 0.12960000E+01 0.33025186E-02 0.11011876E-02 0.11006474E-02 0.11006836E-02 0.12962000E+01 0.33008045E-02 0.11006160E-02 0.11000761E-02 0.11001123E-02 0.12964000E+01 0.32990919E-02 0.11000450E-02 0.10995054E-02 0.10995416E-02 0.12966000E+01 0.32973809E-02 0.10994744E-02 0.10989351E-02 0.10989713E-02 0.12968000E+01 0.32956714E-02 0.10989044E-02 0.10983654E-02 0.10984016E-02 0.12970000E+01 0.32939636E-02 0.10983350E-02 0.10977962E-02 0.10978324E-02 0.12972000E+01 0.32922573E-02 0.10977660E-02 0.10972275E-02 0.10972637E-02 0.12974000E+01 0.32905526E-02 0.10971976E-02 0.10966594E-02 0.10966956E-02 0.12976000E+01 0.32888494E-02 0.10966297E-02 0.10960918E-02 0.10961279E-02 0.12978000E+01 0.32871478E-02 0.10960623E-02 0.10955247E-02 0.10955608E-02 0.12980000E+01 0.32854477E-02 0.10954954E-02 0.10949581E-02 0.10949942E-02 0.12982000E+01 0.32837492E-02 0.10949291E-02 0.10943920E-02 0.10944281E-02 0.12984000E+01 0.32820523E-02 0.10943632E-02 0.10938265E-02 0.10938626E-02 0.12986000E+01 0.32803569E-02 0.10937979E-02 0.10932614E-02 0.10932975E-02 0.12988000E+01 0.32786631E-02 0.10932331E-02 0.10926969E-02 0.10927330E-02 0.12990000E+01 0.32769708E-02 0.10926688E-02 0.10921329E-02 0.10921690E-02 0.12992000E+01 0.32752800E-02 0.10921051E-02 0.10915694E-02 0.10916055E-02 0.12994000E+01 0.32735908E-02 0.10915418E-02 0.10910065E-02 0.10910425E-02 0.12996000E+01 0.32719032E-02 0.10909791E-02 0.10904440E-02 0.10904801E-02 0.12998000E+01 0.32702171E-02 0.10904169E-02 0.10898821E-02 0.10899181E-02 0.13000000E+01 0.32685325E-02 0.10898551E-02 0.10893206E-02 0.10893567E-02 0.13002000E+01 0.32668494E-02 0.10892940E-02 0.10887597E-02 0.10887958E-02 0.13004000E+01 0.32651679E-02 0.10887333E-02 0.10881993E-02 0.10882353E-02 0.13006000E+01 0.32634880E-02 0.10881731E-02 0.10876394E-02 0.10876754E-02 0.13008000E+01 0.32618095E-02 0.10876134E-02 0.10870800E-02 0.10871160E-02 0.13010000E+01 0.32601326E-02 0.10870543E-02 0.10865212E-02 0.10865572E-02 0.13012000E+01 0.32584572E-02 0.10864956E-02 0.10859628E-02 0.10859988E-02 0.13014000E+01 0.32567834E-02 0.10859375E-02 0.10854050E-02 0.10854409E-02 0.13016000E+01 0.32551110E-02 0.10853799E-02 0.10848476E-02 0.10848836E-02 0.13018000E+01 0.32534402E-02 0.10848227E-02 0.10842908E-02 0.10843267E-02 0.13020000E+01 0.32517709E-02 0.10842661E-02 0.10837344E-02 0.10837704E-02 0.13022000E+01 0.32501031E-02 0.10837100E-02 0.10831786E-02 0.10832145E-02 0.13024000E+01 0.32484368E-02 0.10831544E-02 0.10826233E-02 0.10826592E-02 0.13026000E+01 0.32467721E-02 0.10825993E-02 0.10820684E-02 0.10821043E-02 0.13028000E+01 0.32451088E-02 0.10820447E-02 0.10815141E-02 0.10815500E-02 0.13030000E+01 0.32434471E-02 0.10814906E-02 0.10809603E-02 0.10809962E-02 0.13032000E+01 0.32417869E-02 0.10809370E-02 0.10804070E-02 0.10804429E-02 0.13034000E+01 0.32401282E-02 0.10803839E-02 0.10798542E-02 0.10798900E-02 0.13036000E+01 0.32384709E-02 0.10798313E-02 0.10793019E-02 0.10793377E-02 0.13038000E+01 0.32368152E-02 0.10792793E-02 0.10787501E-02 0.10787859E-02 0.13040000E+01 0.32351610E-02 0.10787277E-02 0.10781987E-02 0.10782346E-02 0.13042000E+01 0.32335083E-02 0.10781766E-02 0.10776479E-02 0.10776838E-02 0.13044000E+01 0.32318570E-02 0.10776260E-02 0.10770976E-02 0.10771334E-02 0.13046000E+01 0.32302073E-02 0.10770759E-02 0.10765478E-02 0.10765836E-02 0.13048000E+01 0.32285591E-02 0.10765263E-02 0.10759985E-02 0.10760343E-02 0.13050000E+01 0.32269123E-02 0.10759772E-02 0.10754497E-02 0.10754855E-02 0.13052000E+01 0.32252671E-02 0.10754286E-02 0.10749013E-02 0.10749371E-02 0.13054000E+01 0.32236233E-02 0.10748805E-02 0.10743535E-02 0.10743893E-02 0.13056000E+01 0.32219810E-02 0.10743329E-02 0.10738062E-02 0.10738419E-02 0.13058000E+01 0.32203402E-02 0.10737858E-02 0.10732593E-02 0.10732951E-02 0.13060000E+01 0.32187009E-02 0.10732391E-02 0.10727130E-02 0.10727487E-02 0.13062000E+01 0.32170630E-02 0.10726930E-02 0.10721671E-02 0.10722029E-02 0.13064000E+01 0.32154266E-02 0.10721474E-02 0.10716218E-02 0.10716575E-02 0.13066000E+01 0.32137917E-02 0.10716022E-02 0.10710769E-02 0.10711126E-02 0.13068000E+01 0.32121583E-02 0.10710576E-02 0.10705325E-02 0.10705682E-02 0.13070000E+01 0.32105264E-02 0.10705134E-02 0.10699886E-02 0.10700243E-02 0.13072000E+01 0.32088959E-02 0.10699697E-02 0.10694452E-02 0.10694809E-02 0.13074000E+01 0.32072668E-02 0.10694266E-02 0.10689023E-02 0.10689380E-02 0.13076000E+01 0.32056393E-02 0.10688839E-02 0.10683599E-02 0.10683955E-02 0.13078000E+01 0.32040132E-02 0.10683417E-02 0.10678179E-02 0.10678536E-02 0.13080000E+01 0.32023886E-02 0.10677999E-02 0.10672765E-02 0.10673121E-02 0.13082000E+01 0.32007654E-02 0.10672587E-02 0.10667355E-02 0.10667712E-02 0.13084000E+01 0.31991437E-02 0.10667180E-02 0.10661951E-02 0.10662307E-02 0.13086000E+01 0.31975235E-02 0.10661777E-02 0.10656551E-02 0.10656907E-02 0.13088000E+01 0.31959047E-02 0.10656379E-02 0.10651156E-02 0.10651512E-02 0.13090000E+01 0.31942873E-02 0.10650986E-02 0.10645765E-02 0.10646121E-02 0.13092000E+01 0.31926714E-02 0.10645598E-02 0.10640380E-02 0.10640736E-02 0.13094000E+01 0.31910570E-02 0.10640215E-02 0.10634999E-02 0.10635355E-02 0.13096000E+01 0.31894440E-02 0.10634837E-02 0.10629624E-02 0.10629979E-02 0.13098000E+01 0.31878324E-02 0.10629463E-02 0.10624253E-02 0.10624608E-02 0.13100000E+01 0.31862223E-02 0.10624094E-02 0.10618887E-02 0.10619242E-02 0.13102000E+01 0.31846136E-02 0.10618730E-02 0.10613525E-02 0.10613881E-02 0.13104000E+01 0.31830064E-02 0.10613371E-02 0.10608169E-02 0.10608524E-02 0.13106000E+01 0.31814006E-02 0.10608017E-02 0.10602817E-02 0.10603172E-02 0.13108000E+01 0.31797963E-02 0.10602667E-02 0.10597470E-02 0.10597825E-02 0.13110000E+01 0.31781933E-02 0.10597322E-02 0.10592128E-02 0.10592483E-02 0.13112000E+01 0.31765919E-02 0.10591982E-02 0.10586791E-02 0.10587146E-02 0.13114000E+01 0.31749918E-02 0.10586647E-02 0.10581458E-02 0.10581813E-02 0.13116000E+01 0.31733932E-02 0.10581316E-02 0.10576130E-02 0.10576485E-02 0.13118000E+01 0.31717960E-02 0.10575991E-02 0.10570807E-02 0.10571162E-02 0.13120000E+01 0.31702002E-02 0.10570670E-02 0.10565489E-02 0.10565843E-02 0.13122000E+01 0.31686058E-02 0.10565353E-02 0.10560175E-02 0.10560530E-02 0.13124000E+01 0.31670129E-02 0.10560042E-02 0.10554867E-02 0.10555221E-02 0.13126000E+01 0.31654214E-02 0.10554735E-02 0.10549562E-02 0.10549917E-02 0.13128000E+01 0.31638313E-02 0.10549433E-02 0.10544263E-02 0.10544617E-02 0.13130000E+01 0.31622426E-02 0.10544136E-02 0.10538968E-02 0.10539322E-02 0.13132000E+01 0.31606554E-02 0.10538843E-02 0.10533678E-02 0.10534032E-02 0.13134000E+01 0.31590695E-02 0.10533555E-02 0.10528393E-02 0.10528747E-02 0.13136000E+01 0.31574851E-02 0.10528272E-02 0.10523113E-02 0.10523466E-02 0.13138000E+01 0.31559021E-02 0.10522993E-02 0.10517837E-02 0.10518190E-02 0.13140000E+01 0.31543204E-02 0.10517720E-02 0.10512566E-02 0.10512919E-02 0.13142000E+01 0.31527402E-02 0.10512451E-02 0.10507299E-02 0.10507652E-02 0.13144000E+01 0.31511614E-02 0.10507186E-02 0.10502037E-02 0.10502391E-02 0.13146000E+01 0.31495840E-02 0.10501926E-02 0.10496780E-02 0.10497133E-02 0.13148000E+01 0.31480080E-02 0.10496671E-02 0.10491528E-02 0.10491881E-02 0.13150000E+01 0.31464334E-02 0.10491421E-02 0.10486280E-02 0.10486633E-02 0.13152000E+01 0.31448602E-02 0.10486175E-02 0.10481037E-02 0.10481390E-02 0.13154000E+01 0.31432884E-02 0.10480934E-02 0.10475798E-02 0.10476151E-02 0.13156000E+01 0.31417179E-02 0.10475698E-02 0.10470565E-02 0.10470917E-02 0.13158000E+01 0.31401489E-02 0.10470466E-02 0.10465335E-02 0.10465688E-02 0.13160000E+01 0.31385813E-02 0.10465239E-02 0.10460111E-02 0.10460463E-02 0.13162000E+01 0.31370150E-02 0.10460016E-02 0.10454891E-02 0.10455243E-02 0.13164000E+01 0.31354501E-02 0.10454798E-02 0.10449676E-02 0.10450028E-02 0.13166000E+01 0.31338867E-02 0.10449585E-02 0.10444465E-02 0.10444817E-02 0.13168000E+01 0.31323246E-02 0.10444376E-02 0.10439259E-02 0.10439611E-02 0.13170000E+01 0.31307638E-02 0.10439172E-02 0.10434057E-02 0.10434409E-02 0.13172000E+01 0.31292045E-02 0.10433972E-02 0.10428860E-02 0.10429212E-02 0.13174000E+01 0.31276465E-02 0.10428778E-02 0.10423668E-02 0.10424020E-02 0.13176000E+01 0.31260900E-02 0.10423587E-02 0.10418480E-02 0.10418832E-02 0.13178000E+01 0.31245348E-02 0.10418402E-02 0.10413297E-02 0.10413649E-02 0.13180000E+01 0.31229809E-02 0.10413220E-02 0.10408119E-02 0.10408470E-02 0.13182000E+01 0.31214284E-02 0.10408044E-02 0.10402945E-02 0.10403296E-02 0.13184000E+01 0.31198774E-02 0.10402872E-02 0.10397775E-02 0.10398127E-02 0.13186000E+01 0.31183276E-02 0.10397704E-02 0.10392610E-02 0.10392962E-02 0.13188000E+01 0.31167793E-02 0.10392541E-02 0.10387450E-02 0.10387801E-02 0.13190000E+01 0.31152323E-02 0.10387383E-02 0.10382294E-02 0.10382645E-02 0.13192000E+01 0.31136866E-02 0.10382229E-02 0.10377143E-02 0.10377494E-02 0.13194000E+01 0.31121424E-02 0.10377080E-02 0.10371996E-02 0.10372347E-02 0.13196000E+01 0.31105994E-02 0.10371935E-02 0.10366854E-02 0.10367205E-02 0.13198000E+01 0.31090579E-02 0.10366795E-02 0.10361717E-02 0.10362067E-02 0.13200000E+01 0.31075177E-02 0.10361659E-02 0.10356583E-02 0.10356934E-02 0.13202000E+01 0.31059788E-02 0.10356528E-02 0.10351455E-02 0.10351805E-02 0.13204000E+01 0.31044413E-02 0.10351402E-02 0.10346331E-02 0.10346681E-02 0.13206000E+01 0.31029052E-02 0.10346279E-02 0.10341211E-02 0.10341561E-02 0.13208000E+01 0.31013704E-02 0.10341162E-02 0.10336096E-02 0.10336446E-02 0.13210000E+01 0.30998370E-02 0.10336049E-02 0.10330985E-02 0.10331335E-02 0.13212000E+01 0.30983048E-02 0.10330940E-02 0.10325879E-02 0.10326229E-02 0.13214000E+01 0.30967741E-02 0.10325836E-02 0.10320778E-02 0.10321128E-02 0.13216000E+01 0.30952447E-02 0.10320736E-02 0.10315681E-02 0.10316030E-02 0.13218000E+01 0.30937166E-02 0.10315641E-02 0.10310588E-02 0.10310937E-02 0.13220000E+01 0.30921899E-02 0.10310550E-02 0.10305500E-02 0.10305849E-02 0.13222000E+01 0.30906645E-02 0.10305464E-02 0.10300416E-02 0.10300765E-02 0.13224000E+01 0.30891404E-02 0.10300382E-02 0.10295337E-02 0.10295686E-02 0.13226000E+01 0.30876177E-02 0.10295304E-02 0.10290262E-02 0.10290611E-02 0.13228000E+01 0.30860963E-02 0.10290231E-02 0.10285191E-02 0.10285540E-02 0.13230000E+01 0.30845762E-02 0.10285163E-02 0.10280125E-02 0.10280474E-02 0.13232000E+01 0.30830575E-02 0.10280099E-02 0.10275064E-02 0.10275413E-02 0.13234000E+01 0.30815401E-02 0.10275039E-02 0.10270006E-02 0.10270355E-02 0.13236000E+01 0.30800240E-02 0.10269984E-02 0.10264954E-02 0.10265302E-02 0.13238000E+01 0.30785092E-02 0.10264933E-02 0.10259905E-02 0.10260254E-02 0.13240000E+01 0.30769958E-02 0.10259886E-02 0.10254862E-02 0.10255210E-02 0.13242000E+01 0.30754837E-02 0.10254844E-02 0.10249822E-02 0.10250170E-02 0.13244000E+01 0.30739729E-02 0.10249807E-02 0.10244787E-02 0.10245135E-02 0.13246000E+01 0.30724634E-02 0.10244774E-02 0.10239756E-02 0.10240104E-02 0.13248000E+01 0.30709553E-02 0.10239745E-02 0.10234730E-02 0.10235078E-02 0.13250000E+01 0.30694484E-02 0.10234720E-02 0.10229708E-02 0.10230056E-02 0.13252000E+01 0.30679429E-02 0.10229700E-02 0.10224690E-02 0.10225038E-02 0.13254000E+01 0.30664387E-02 0.10224684E-02 0.10219677E-02 0.10220025E-02 0.13256000E+01 0.30649357E-02 0.10219673E-02 0.10214668E-02 0.10215016E-02 0.13258000E+01 0.30634341E-02 0.10214666E-02 0.10209664E-02 0.10210011E-02 0.13260000E+01 0.30619338E-02 0.10209663E-02 0.10204664E-02 0.10205011E-02 0.13262000E+01 0.30604349E-02 0.10204665E-02 0.10199668E-02 0.10200015E-02 0.13264000E+01 0.30589372E-02 0.10199671E-02 0.10194676E-02 0.10195024E-02 0.13266000E+01 0.30574408E-02 0.10194682E-02 0.10189689E-02 0.10190037E-02 0.13268000E+01 0.30559457E-02 0.10189696E-02 0.10184707E-02 0.10185054E-02 0.13270000E+01 0.30544519E-02 0.10184716E-02 0.10179728E-02 0.10180075E-02 0.13272000E+01 0.30529594E-02 0.10179739E-02 0.10174754E-02 0.10175101E-02 0.13274000E+01 0.30514682E-02 0.10174767E-02 0.10169784E-02 0.10170131E-02 0.13276000E+01 0.30499783E-02 0.10169799E-02 0.10164819E-02 0.10165166E-02 0.13278000E+01 0.30484897E-02 0.10164835E-02 0.10159858E-02 0.10160204E-02 0.13280000E+01 0.30470024E-02 0.10159876E-02 0.10154901E-02 0.10155247E-02 0.13282000E+01 0.30455164E-02 0.10154921E-02 0.10149948E-02 0.10150295E-02 0.13284000E+01 0.30440316E-02 0.10149970E-02 0.10145000E-02 0.10145346E-02 0.13286000E+01 0.30425482E-02 0.10145023E-02 0.10140056E-02 0.10140402E-02 0.13288000E+01 0.30410660E-02 0.10140081E-02 0.10135116E-02 0.10135462E-02 0.13290000E+01 0.30395851E-02 0.10135143E-02 0.10130181E-02 0.10130527E-02 0.13292000E+01 0.30381055E-02 0.10130210E-02 0.10125250E-02 0.10125596E-02 0.13294000E+01 0.30366272E-02 0.10125280E-02 0.10120323E-02 0.10120669E-02 0.13296000E+01 0.30351501E-02 0.10120355E-02 0.10115400E-02 0.10115746E-02 0.13298000E+01 0.30336743E-02 0.10115434E-02 0.10110482E-02 0.10110827E-02 0.13300000E+01 0.30321998E-02 0.10110518E-02 0.10105568E-02 0.10105913E-02 0.13302000E+01 0.30307266E-02 0.10105605E-02 0.10100658E-02 0.10101003E-02 0.13304000E+01 0.30292546E-02 0.10100697E-02 0.10095752E-02 0.10096097E-02 0.13306000E+01 0.30277840E-02 0.10095793E-02 0.10090851E-02 0.10091196E-02 0.13308000E+01 0.30263145E-02 0.10090894E-02 0.10085953E-02 0.10086299E-02 0.13310000E+01 0.30248464E-02 0.10085998E-02 0.10081060E-02 0.10081405E-02 0.13312000E+01 0.30233795E-02 0.10081107E-02 0.10076172E-02 0.10076517E-02 0.13314000E+01 0.30219139E-02 0.10076220E-02 0.10071287E-02 0.10071632E-02 0.13316000E+01 0.30204495E-02 0.10071337E-02 0.10066407E-02 0.10066752E-02 0.13318000E+01 0.30189865E-02 0.10066459E-02 0.10061531E-02 0.10061875E-02 0.13320000E+01 0.30175246E-02 0.10061584E-02 0.10056659E-02 0.10057003E-02 0.13322000E+01 0.30160640E-02 0.10056714E-02 0.10051791E-02 0.10052135E-02 0.13324000E+01 0.30146047E-02 0.10051848E-02 0.10046927E-02 0.10047272E-02 0.13326000E+01 0.30131467E-02 0.10046986E-02 0.10042068E-02 0.10042412E-02 0.13328000E+01 0.30116898E-02 0.10042129E-02 0.10037213E-02 0.10037557E-02 0.13330000E+01 0.30102343E-02 0.10037275E-02 0.10032362E-02 0.10032706E-02 0.13332000E+01 0.30087800E-02 0.10032426E-02 0.10027515E-02 0.10027859E-02 0.13334000E+01 0.30073269E-02 0.10027581E-02 0.10022672E-02 0.10023016E-02 0.13336000E+01 0.30058751E-02 0.10022740E-02 0.10017834E-02 0.10018178E-02 0.13338000E+01 0.30044245E-02 0.10017903E-02 0.10012999E-02 0.10013343E-02 0.13340000E+01 0.30029752E-02 0.10013070E-02 0.10008169E-02 0.10008513E-02 0.13342000E+01 0.30015271E-02 0.10008242E-02 0.10003343E-02 0.10003686E-02 0.13344000E+01 0.30000803E-02 0.10003417E-02 0.99985209E-03 0.99988644E-03 0.13346000E+01 0.29986347E-02 0.99985972E-03 0.99937031E-03 0.99940465E-03 0.13348000E+01 0.29971903E-02 0.99937811E-03 0.99888894E-03 0.99892327E-03 0.13350000E+01 0.29957472E-02 0.99889691E-03 0.99840798E-03 0.99844230E-03 0.13352000E+01 0.29943053E-02 0.99841613E-03 0.99792743E-03 0.99796175E-03 0.13354000E+01 0.29928647E-02 0.99793575E-03 0.99744730E-03 0.99748160E-03 0.13356000E+01 0.29914252E-02 0.99745579E-03 0.99696758E-03 0.99700187E-03 0.13358000E+01 0.29899870E-02 0.99697623E-03 0.99648826E-03 0.99652254E-03 0.13360000E+01 0.29885501E-02 0.99649709E-03 0.99600936E-03 0.99604363E-03 0.13362000E+01 0.29871143E-02 0.99601835E-03 0.99553086E-03 0.99556513E-03 0.13364000E+01 0.29856798E-02 0.99554003E-03 0.99505277E-03 0.99508703E-03 0.13366000E+01 0.29842465E-02 0.99506211E-03 0.99457510E-03 0.99460934E-03 0.13368000E+01 0.29828145E-02 0.99458460E-03 0.99409783E-03 0.99413206E-03 0.13370000E+01 0.29813837E-02 0.99410750E-03 0.99362096E-03 0.99365519E-03 0.13372000E+01 0.29799540E-02 0.99363080E-03 0.99314451E-03 0.99317872E-03 0.13374000E+01 0.29785256E-02 0.99315452E-03 0.99266846E-03 0.99270266E-03 0.13376000E+01 0.29770985E-02 0.99267863E-03 0.99219281E-03 0.99222701E-03 0.13378000E+01 0.29756725E-02 0.99220316E-03 0.99171757E-03 0.99175176E-03 0.13380000E+01 0.29742477E-02 0.99172808E-03 0.99124274E-03 0.99127692E-03 0.13382000E+01 0.29728242E-02 0.99125342E-03 0.99076831E-03 0.99080248E-03 0.13384000E+01 0.29714019E-02 0.99077915E-03 0.99029428E-03 0.99032844E-03 0.13386000E+01 0.29699808E-02 0.99030529E-03 0.98982066E-03 0.98985481E-03 0.13388000E+01 0.29685609E-02 0.98983184E-03 0.98934744E-03 0.98938158E-03 0.13390000E+01 0.29671422E-02 0.98935878E-03 0.98887462E-03 0.98890875E-03 0.13392000E+01 0.29657247E-02 0.98888613E-03 0.98840221E-03 0.98843633E-03 0.13394000E+01 0.29643084E-02 0.98841388E-03 0.98793019E-03 0.98796430E-03 0.13396000E+01 0.29628933E-02 0.98794203E-03 0.98745858E-03 0.98749268E-03 0.13398000E+01 0.29614794E-02 0.98747058E-03 0.98698737E-03 0.98702146E-03 0.13400000E+01 0.29600667E-02 0.98699953E-03 0.98651655E-03 0.98655064E-03 0.13402000E+01 0.29586552E-02 0.98652889E-03 0.98604614E-03 0.98608021E-03 0.13404000E+01 0.29572450E-02 0.98605864E-03 0.98557613E-03 0.98561019E-03 0.13406000E+01 0.29558359E-02 0.98558879E-03 0.98510651E-03 0.98514057E-03 0.13408000E+01 0.29544280E-02 0.98511933E-03 0.98463729E-03 0.98467134E-03 0.13410000E+01 0.29530213E-02 0.98465028E-03 0.98416847E-03 0.98420251E-03 0.13412000E+01 0.29516157E-02 0.98418162E-03 0.98370005E-03 0.98373408E-03 0.13414000E+01 0.29502114E-02 0.98371336E-03 0.98323202E-03 0.98326604E-03 0.13416000E+01 0.29488083E-02 0.98324550E-03 0.98276439E-03 0.98279840E-03 0.13418000E+01 0.29474063E-02 0.98277803E-03 0.98229716E-03 0.98233116E-03 0.13420000E+01 0.29460056E-02 0.98231096E-03 0.98183032E-03 0.98186431E-03 0.13422000E+01 0.29446060E-02 0.98184428E-03 0.98136388E-03 0.98139785E-03 0.13424000E+01 0.29432076E-02 0.98137800E-03 0.98089783E-03 0.98093180E-03 0.13426000E+01 0.29418104E-02 0.98091211E-03 0.98043217E-03 0.98046613E-03 0.13428000E+01 0.29404144E-02 0.98044661E-03 0.97996691E-03 0.98000086E-03 0.13430000E+01 0.29390195E-02 0.97998151E-03 0.97950204E-03 0.97953598E-03 0.13432000E+01 0.29376258E-02 0.97951680E-03 0.97903756E-03 0.97907149E-03 0.13434000E+01 0.29362333E-02 0.97905248E-03 0.97857347E-03 0.97860740E-03 0.13436000E+01 0.29348420E-02 0.97858855E-03 0.97810978E-03 0.97814369E-03 0.13438000E+01 0.29334519E-02 0.97812502E-03 0.97764648E-03 0.97768038E-03 0.13440000E+01 0.29320629E-02 0.97766187E-03 0.97718356E-03 0.97721746E-03 0.13442000E+01 0.29306751E-02 0.97719912E-03 0.97672104E-03 0.97675492E-03 0.13444000E+01 0.29292884E-02 0.97673676E-03 0.97625891E-03 0.97629278E-03 0.13446000E+01 0.29279030E-02 0.97627478E-03 0.97579716E-03 0.97583103E-03 0.13448000E+01 0.29265187E-02 0.97581320E-03 0.97533581E-03 0.97536966E-03 0.13450000E+01 0.29251355E-02 0.97535200E-03 0.97487484E-03 0.97490869E-03 0.13452000E+01 0.29237536E-02 0.97489119E-03 0.97441426E-03 0.97444810E-03 0.13454000E+01 0.29223727E-02 0.97443077E-03 0.97395407E-03 0.97398790E-03 0.13456000E+01 0.29209931E-02 0.97397073E-03 0.97349427E-03 0.97352808E-03 0.13458000E+01 0.29196146E-02 0.97351108E-03 0.97303485E-03 0.97306866E-03 0.13460000E+01 0.29182372E-02 0.97305182E-03 0.97257581E-03 0.97260961E-03 0.13462000E+01 0.29168611E-02 0.97259294E-03 0.97211717E-03 0.97215096E-03 0.13464000E+01 0.29154860E-02 0.97213445E-03 0.97165890E-03 0.97169269E-03 0.13466000E+01 0.29141122E-02 0.97167635E-03 0.97120103E-03 0.97123480E-03 0.13468000E+01 0.29127395E-02 0.97121862E-03 0.97074353E-03 0.97077730E-03 0.13470000E+01 0.29113679E-02 0.97076129E-03 0.97028642E-03 0.97032018E-03 0.13472000E+01 0.29099975E-02 0.97030433E-03 0.96982970E-03 0.96986344E-03 0.13474000E+01 0.29086282E-02 0.96984776E-03 0.96937335E-03 0.96940709E-03 0.13476000E+01 0.29072601E-02 0.96939157E-03 0.96891739E-03 0.96895112E-03 0.13478000E+01 0.29058931E-02 0.96893576E-03 0.96846181E-03 0.96849553E-03 0.13480000E+01 0.29045273E-02 0.96848033E-03 0.96800661E-03 0.96804032E-03 0.13482000E+01 0.29031626E-02 0.96802529E-03 0.96755180E-03 0.96758549E-03 0.13484000E+01 0.29017990E-02 0.96757063E-03 0.96709736E-03 0.96713104E-03 0.13486000E+01 0.29004366E-02 0.96711634E-03 0.96664330E-03 0.96667698E-03 0.13488000E+01 0.28990754E-02 0.96666244E-03 0.96618962E-03 0.96622329E-03 0.13490000E+01 0.28977152E-02 0.96620891E-03 0.96573633E-03 0.96576998E-03 0.13492000E+01 0.28963562E-02 0.96575577E-03 0.96528341E-03 0.96531706E-03 0.13494000E+01 0.28949984E-02 0.96530300E-03 0.96483086E-03 0.96486450E-03 0.13496000E+01 0.28936416E-02 0.96485061E-03 0.96437870E-03 0.96441233E-03 0.13498000E+01 0.28922860E-02 0.96439860E-03 0.96392692E-03 0.96396054E-03 0.13500000E+01 0.28909316E-02 0.96394696E-03 0.96347551E-03 0.96350912E-03 0.13502000E+01 0.28895783E-02 0.96349570E-03 0.96302447E-03 0.96305808E-03 0.13504000E+01 0.28882260E-02 0.96304482E-03 0.96257382E-03 0.96260741E-03 0.13506000E+01 0.28868750E-02 0.96259431E-03 0.96212354E-03 0.96215712E-03 0.13508000E+01 0.28855250E-02 0.96214418E-03 0.96167363E-03 0.96170720E-03 0.13510000E+01 0.28841762E-02 0.96169443E-03 0.96122410E-03 0.96125766E-03 0.13512000E+01 0.28828285E-02 0.96124505E-03 0.96077494E-03 0.96080850E-03 0.13514000E+01 0.28814819E-02 0.96079604E-03 0.96032616E-03 0.96035970E-03 0.13516000E+01 0.28801364E-02 0.96034740E-03 0.95987775E-03 0.95991128E-03 0.13518000E+01 0.28787921E-02 0.95989914E-03 0.95942971E-03 0.95946324E-03 0.13520000E+01 0.28774489E-02 0.95945125E-03 0.95898205E-03 0.95901556E-03 0.13522000E+01 0.28761068E-02 0.95900374E-03 0.95853475E-03 0.95856826E-03 0.13524000E+01 0.28747658E-02 0.95855659E-03 0.95808783E-03 0.95812133E-03 0.13526000E+01 0.28734259E-02 0.95810982E-03 0.95764128E-03 0.95767477E-03 0.13528000E+01 0.28720871E-02 0.95766342E-03 0.95719510E-03 0.95722858E-03 0.13530000E+01 0.28707495E-02 0.95721739E-03 0.95674930E-03 0.95678277E-03 0.13532000E+01 0.28694129E-02 0.95677173E-03 0.95630386E-03 0.95633732E-03 0.13534000E+01 0.28680775E-02 0.95632644E-03 0.95585879E-03 0.95589224E-03 0.13536000E+01 0.28667431E-02 0.95588151E-03 0.95541409E-03 0.95544753E-03 0.13538000E+01 0.28654099E-02 0.95543696E-03 0.95496976E-03 0.95500319E-03 0.13540000E+01 0.28640778E-02 0.95499277E-03 0.95452579E-03 0.95455922E-03 0.13542000E+01 0.28627468E-02 0.95454896E-03 0.95408220E-03 0.95411561E-03 0.13544000E+01 0.28614168E-02 0.95410551E-03 0.95363897E-03 0.95367237E-03 0.13546000E+01 0.28600880E-02 0.95366242E-03 0.95319611E-03 0.95322950E-03 0.13548000E+01 0.28587603E-02 0.95321971E-03 0.95275361E-03 0.95278700E-03 0.13550000E+01 0.28574337E-02 0.95277736E-03 0.95231148E-03 0.95234486E-03 0.13552000E+01 0.28561082E-02 0.95233537E-03 0.95186972E-03 0.95190309E-03 0.13554000E+01 0.28547838E-02 0.95189375E-03 0.95142832E-03 0.95146168E-03 0.13556000E+01 0.28534604E-02 0.95145250E-03 0.95098729E-03 0.95102064E-03 0.13558000E+01 0.28521382E-02 0.95101161E-03 0.95054662E-03 0.95057996E-03 0.13560000E+01 0.28508170E-02 0.95057109E-03 0.95010631E-03 0.95013964E-03 0.13562000E+01 0.28494970E-02 0.95013092E-03 0.94966637E-03 0.94969969E-03 0.13564000E+01 0.28481780E-02 0.94969112E-03 0.94922679E-03 0.94926011E-03 0.13566000E+01 0.28468601E-02 0.94925169E-03 0.94878758E-03 0.94882088E-03 0.13568000E+01 0.28455434E-02 0.94881262E-03 0.94834872E-03 0.94838202E-03 0.13570000E+01 0.28442276E-02 0.94837390E-03 0.94791023E-03 0.94794351E-03 0.13572000E+01 0.28429130E-02 0.94793555E-03 0.94747210E-03 0.94750537E-03 0.13574000E+01 0.28415995E-02 0.94749756E-03 0.94703433E-03 0.94706759E-03 0.13576000E+01 0.28402870E-02 0.94705994E-03 0.94659692E-03 0.94663018E-03 0.13578000E+01 0.28389757E-02 0.94662267E-03 0.94615987E-03 0.94619312E-03 0.13580000E+01 0.28376654E-02 0.94618576E-03 0.94572318E-03 0.94575642E-03 0.13582000E+01 0.28363561E-02 0.94574921E-03 0.94528685E-03 0.94532008E-03 0.13584000E+01 0.28350480E-02 0.94531302E-03 0.94485088E-03 0.94488410E-03 0.13586000E+01 0.28337409E-02 0.94487719E-03 0.94441526E-03 0.94444848E-03 0.13588000E+01 0.28324349E-02 0.94444172E-03 0.94398001E-03 0.94401321E-03 0.13590000E+01 0.28311300E-02 0.94400660E-03 0.94354511E-03 0.94357830E-03 0.13592000E+01 0.28298262E-02 0.94357185E-03 0.94311057E-03 0.94314375E-03 0.13594000E+01 0.28285234E-02 0.94313745E-03 0.94267639E-03 0.94270956E-03 0.13596000E+01 0.28272217E-02 0.94270340E-03 0.94224256E-03 0.94227572E-03 0.13598000E+01 0.28259210E-02 0.94226971E-03 0.94180909E-03 0.94184224E-03 0.13600000E+01 0.28246215E-02 0.94183638E-03 0.94137597E-03 0.94140912E-03 0.13602000E+01 0.28233230E-02 0.94140340E-03 0.94094321E-03 0.94097635E-03 0.13604000E+01 0.28220255E-02 0.94097078E-03 0.94051080E-03 0.94054393E-03 0.13606000E+01 0.28207291E-02 0.94053851E-03 0.94007875E-03 0.94011187E-03 0.13608000E+01 0.28194338E-02 0.94010660E-03 0.93964705E-03 0.93968016E-03 0.13610000E+01 0.28181396E-02 0.93967504E-03 0.93921571E-03 0.93924881E-03 0.13612000E+01 0.28168464E-02 0.93924383E-03 0.93878472E-03 0.93881781E-03 0.13614000E+01 0.28155542E-02 0.93881298E-03 0.93835408E-03 0.93838716E-03 0.13616000E+01 0.28142631E-02 0.93838248E-03 0.93792379E-03 0.93795687E-03 0.13618000E+01 0.28129731E-02 0.93795233E-03 0.93749386E-03 0.93752692E-03 0.13620000E+01 0.28116841E-02 0.93752253E-03 0.93706427E-03 0.93709733E-03 0.13622000E+01 0.28103962E-02 0.93709308E-03 0.93663504E-03 0.93666809E-03 0.13624000E+01 0.28091093E-02 0.93666399E-03 0.93620616E-03 0.93623920E-03 0.13626000E+01 0.28078235E-02 0.93623524E-03 0.93577763E-03 0.93581066E-03 0.13628000E+01 0.28065388E-02 0.93580685E-03 0.93534945E-03 0.93538247E-03 0.13630000E+01 0.28052550E-02 0.93537880E-03 0.93492161E-03 0.93495462E-03 0.13632000E+01 0.28039724E-02 0.93495110E-03 0.93449413E-03 0.93452713E-03 0.13634000E+01 0.28026907E-02 0.93452375E-03 0.93406700E-03 0.93409999E-03 0.13636000E+01 0.28014102E-02 0.93409675E-03 0.93364021E-03 0.93367319E-03 0.13638000E+01 0.28001306E-02 0.93367010E-03 0.93321377E-03 0.93324674E-03 0.13640000E+01 0.27988521E-02 0.93324380E-03 0.93278768E-03 0.93282064E-03 0.13642000E+01 0.27975747E-02 0.93281784E-03 0.93236194E-03 0.93239489E-03 0.13644000E+01 0.27962983E-02 0.93239223E-03 0.93193654E-03 0.93196948E-03 0.13646000E+01 0.27950229E-02 0.93196697E-03 0.93151149E-03 0.93154442E-03 0.13648000E+01 0.27937485E-02 0.93154205E-03 0.93108678E-03 0.93111971E-03 0.13650000E+01 0.27924752E-02 0.93111748E-03 0.93066242E-03 0.93069534E-03 0.13652000E+01 0.27912030E-02 0.93069325E-03 0.93023841E-03 0.93027131E-03 0.13654000E+01 0.27899317E-02 0.93026937E-03 0.92981473E-03 0.92984763E-03 0.13656000E+01 0.27886615E-02 0.92984583E-03 0.92939141E-03 0.92942430E-03 0.13658000E+01 0.27873924E-02 0.92942264E-03 0.92896843E-03 0.92900131E-03 0.13660000E+01 0.27861242E-02 0.92899979E-03 0.92854579E-03 0.92857866E-03 0.13662000E+01 0.27848571E-02 0.92857728E-03 0.92812349E-03 0.92815635E-03 0.13664000E+01 0.27835910E-02 0.92815511E-03 0.92770154E-03 0.92773439E-03 0.13666000E+01 0.27823260E-02 0.92773329E-03 0.92727993E-03 0.92731277E-03 0.13668000E+01 0.27810620E-02 0.92731181E-03 0.92685866E-03 0.92689149E-03 0.13670000E+01 0.27797990E-02 0.92689067E-03 0.92643773E-03 0.92647055E-03 0.13672000E+01 0.27785370E-02 0.92646988E-03 0.92601714E-03 0.92604996E-03 0.13674000E+01 0.27772760E-02 0.92604942E-03 0.92559689E-03 0.92562970E-03 0.13676000E+01 0.27760161E-02 0.92562931E-03 0.92517699E-03 0.92520979E-03 0.13678000E+01 0.27747572E-02 0.92520953E-03 0.92475742E-03 0.92479021E-03 0.13680000E+01 0.27734993E-02 0.92479009E-03 0.92433820E-03 0.92437098E-03 0.13682000E+01 0.27722424E-02 0.92437100E-03 0.92391931E-03 0.92395208E-03 0.13684000E+01 0.27709865E-02 0.92395224E-03 0.92350076E-03 0.92353352E-03 0.13686000E+01 0.27697317E-02 0.92353382E-03 0.92308255E-03 0.92311530E-03 0.13688000E+01 0.27684778E-02 0.92311574E-03 0.92266468E-03 0.92269742E-03 0.13690000E+01 0.27672250E-02 0.92269800E-03 0.92224714E-03 0.92227988E-03 0.13692000E+01 0.27659732E-02 0.92228059E-03 0.92182995E-03 0.92186267E-03 0.13694000E+01 0.27647224E-02 0.92186352E-03 0.92141309E-03 0.92144580E-03 0.13696000E+01 0.27634726E-02 0.92144679E-03 0.92099656E-03 0.92102927E-03 0.13698000E+01 0.27622238E-02 0.92103039E-03 0.92058037E-03 0.92061307E-03 0.13700000E+01 0.27609761E-02 0.92061433E-03 0.92016452E-03 0.92019721E-03 0.13702000E+01 0.27597293E-02 0.92019861E-03 0.91974900E-03 0.91978168E-03 0.13704000E+01 0.27584835E-02 0.91978322E-03 0.91933382E-03 0.91936649E-03 0.13706000E+01 0.27572388E-02 0.91936816E-03 0.91891897E-03 0.91895164E-03 0.13708000E+01 0.27559950E-02 0.91895344E-03 0.91850446E-03 0.91853711E-03 0.13710000E+01 0.27547523E-02 0.91853906E-03 0.91809028E-03 0.91812292E-03 0.13712000E+01 0.27535105E-02 0.91812500E-03 0.91767643E-03 0.91770907E-03 0.13714000E+01 0.27522697E-02 0.91771128E-03 0.91726292E-03 0.91729554E-03 0.13716000E+01 0.27510300E-02 0.91729790E-03 0.91684974E-03 0.91688235E-03 0.13718000E+01 0.27497912E-02 0.91688484E-03 0.91643689E-03 0.91646950E-03 0.13720000E+01 0.27485535E-02 0.91647212E-03 0.91602437E-03 0.91605697E-03 0.13722000E+01 0.27473167E-02 0.91605973E-03 0.91561219E-03 0.91564478E-03 0.13724000E+01 0.27460809E-02 0.91564767E-03 0.91520033E-03 0.91523291E-03 0.13726000E+01 0.27448461E-02 0.91523594E-03 0.91478881E-03 0.91482138E-03 0.13728000E+01 0.27436123E-02 0.91482454E-03 0.91437762E-03 0.91441018E-03 0.13730000E+01 0.27423795E-02 0.91441347E-03 0.91396675E-03 0.91399931E-03 0.13732000E+01 0.27411477E-02 0.91400273E-03 0.91355622E-03 0.91358876E-03 0.13734000E+01 0.27399169E-02 0.91359232E-03 0.91314601E-03 0.91317855E-03 0.13736000E+01 0.27386870E-02 0.91318224E-03 0.91273614E-03 0.91276867E-03 0.13738000E+01 0.27374582E-02 0.91277249E-03 0.91232659E-03 0.91235911E-03 0.13740000E+01 0.27362303E-02 0.91236307E-03 0.91191737E-03 0.91194988E-03 0.13742000E+01 0.27350034E-02 0.91195397E-03 0.91150848E-03 0.91154098E-03 0.13744000E+01 0.27337775E-02 0.91154521E-03 0.91109992E-03 0.91113241E-03 0.13746000E+01 0.27325526E-02 0.91113676E-03 0.91069168E-03 0.91072416E-03 0.13748000E+01 0.27313287E-02 0.91072865E-03 0.91028377E-03 0.91031624E-03 0.13750000E+01 0.27301057E-02 0.91032086E-03 0.90987619E-03 0.90990865E-03 0.13752000E+01 0.27288837E-02 0.90991340E-03 0.90946893E-03 0.90950138E-03 0.13754000E+01 0.27276627E-02 0.90950627E-03 0.90906200E-03 0.90909444E-03 0.13756000E+01 0.27264427E-02 0.90909946E-03 0.90865539E-03 0.90868783E-03 0.13758000E+01 0.27252236E-02 0.90869297E-03 0.90824911E-03 0.90828154E-03 0.13760000E+01 0.27240055E-02 0.90828681E-03 0.90784315E-03 0.90787557E-03 0.13762000E+01 0.27227884E-02 0.90788097E-03 0.90743751E-03 0.90746993E-03 0.13764000E+01 0.27215723E-02 0.90747546E-03 0.90703220E-03 0.90706461E-03 0.13766000E+01 0.27203571E-02 0.90707027E-03 0.90662722E-03 0.90665961E-03 0.13768000E+01 0.27191429E-02 0.90666541E-03 0.90622255E-03 0.90625494E-03 0.13770000E+01 0.27179297E-02 0.90626086E-03 0.90581821E-03 0.90585059E-03 0.13772000E+01 0.27167174E-02 0.90585664E-03 0.90541419E-03 0.90544656E-03 0.13774000E+01 0.27155061E-02 0.90545274E-03 0.90501050E-03 0.90504285E-03 0.13776000E+01 0.27142958E-02 0.90504917E-03 0.90460712E-03 0.90463947E-03 0.13778000E+01 0.27130864E-02 0.90464591E-03 0.90420407E-03 0.90423640E-03 0.13780000E+01 0.27118780E-02 0.90424298E-03 0.90380133E-03 0.90383366E-03 0.13782000E+01 0.27106705E-02 0.90384036E-03 0.90339892E-03 0.90343124E-03 0.13784000E+01 0.27094640E-02 0.90343807E-03 0.90299682E-03 0.90302914E-03 0.13786000E+01 0.27082585E-02 0.90303609E-03 0.90259505E-03 0.90262735E-03 0.13788000E+01 0.27070539E-02 0.90263444E-03 0.90219360E-03 0.90222589E-03 0.13790000E+01 0.27058503E-02 0.90223310E-03 0.90179246E-03 0.90182475E-03 0.13792000E+01 0.27046477E-02 0.90183209E-03 0.90139165E-03 0.90142392E-03 0.13794000E+01 0.27034460E-02 0.90143139E-03 0.90099115E-03 0.90102341E-03 0.13796000E+01 0.27022452E-02 0.90103101E-03 0.90059097E-03 0.90062323E-03 0.13798000E+01 0.27010454E-02 0.90063095E-03 0.90019110E-03 0.90022335E-03 0.13800000E+01 0.26998466E-02 0.90023120E-03 0.89979156E-03 0.89982380E-03 0.13802000E+01 0.26986487E-02 0.89983177E-03 0.89939233E-03 0.89942456E-03 0.13804000E+01 0.26974517E-02 0.89943266E-03 0.89899342E-03 0.89902564E-03 0.13806000E+01 0.26962557E-02 0.89903387E-03 0.89859482E-03 0.89862704E-03 0.13808000E+01 0.26950607E-02 0.89863539E-03 0.89819654E-03 0.89822875E-03 0.13810000E+01 0.26938666E-02 0.89823722E-03 0.89779858E-03 0.89783077E-03 0.13812000E+01 0.26926734E-02 0.89783938E-03 0.89740093E-03 0.89743311E-03 0.13814000E+01 0.26914812E-02 0.89744184E-03 0.89700359E-03 0.89703577E-03 0.13816000E+01 0.26902899E-02 0.89704462E-03 0.89660657E-03 0.89663874E-03 0.13818000E+01 0.26890996E-02 0.89664772E-03 0.89620986E-03 0.89624202E-03 0.13820000E+01 0.26879102E-02 0.89625113E-03 0.89581347E-03 0.89584562E-03 0.13822000E+01 0.26867218E-02 0.89585485E-03 0.89541739E-03 0.89544953E-03 0.13824000E+01 0.26855343E-02 0.89545889E-03 0.89502162E-03 0.89505376E-03 0.13826000E+01 0.26843477E-02 0.89506324E-03 0.89462617E-03 0.89465830E-03 0.13828000E+01 0.26831621E-02 0.89466790E-03 0.89423103E-03 0.89426314E-03 0.13830000E+01 0.26819774E-02 0.89427287E-03 0.89383620E-03 0.89386831E-03 0.13832000E+01 0.26807936E-02 0.89387815E-03 0.89344168E-03 0.89347378E-03 0.13834000E+01 0.26796108E-02 0.89348375E-03 0.89304747E-03 0.89307956E-03 0.13836000E+01 0.26784289E-02 0.89308966E-03 0.89265358E-03 0.89268566E-03 0.13838000E+01 0.26772479E-02 0.89269588E-03 0.89225999E-03 0.89229206E-03 0.13840000E+01 0.26760679E-02 0.89230241E-03 0.89186672E-03 0.89189878E-03 0.13842000E+01 0.26748888E-02 0.89190924E-03 0.89147375E-03 0.89150581E-03 0.13844000E+01 0.26737106E-02 0.89151639E-03 0.89108109E-03 0.89111314E-03 0.13846000E+01 0.26725334E-02 0.89112385E-03 0.89068875E-03 0.89072078E-03 0.13848000E+01 0.26713571E-02 0.89073162E-03 0.89029671E-03 0.89032874E-03 0.13850000E+01 0.26701817E-02 0.89033969E-03 0.88990498E-03 0.88993700E-03 0.13852000E+01 0.26690072E-02 0.88994807E-03 0.88951356E-03 0.88954557E-03 0.13854000E+01 0.26678337E-02 0.88955676E-03 0.88912244E-03 0.88915445E-03 0.13856000E+01 0.26666610E-02 0.88916576E-03 0.88873164E-03 0.88876363E-03 0.13858000E+01 0.26654893E-02 0.88877507E-03 0.88834114E-03 0.88837312E-03 0.13860000E+01 0.26643186E-02 0.88838468E-03 0.88795095E-03 0.88798292E-03 0.13862000E+01 0.26631487E-02 0.88799460E-03 0.88756106E-03 0.88759303E-03 0.13864000E+01 0.26619797E-02 0.88760483E-03 0.88717148E-03 0.88720344E-03 0.13866000E+01 0.26608117E-02 0.88721536E-03 0.88678221E-03 0.88681416E-03 0.13868000E+01 0.26596446E-02 0.88682620E-03 0.88639324E-03 0.88642518E-03 0.13870000E+01 0.26584784E-02 0.88643734E-03 0.88600457E-03 0.88603651E-03 0.13872000E+01 0.26573131E-02 0.88604879E-03 0.88561622E-03 0.88564814E-03 0.13874000E+01 0.26561488E-02 0.88566054E-03 0.88522816E-03 0.88526007E-03 0.13876000E+01 0.26549853E-02 0.88527259E-03 0.88484041E-03 0.88487232E-03 0.13878000E+01 0.26538228E-02 0.88488495E-03 0.88445296E-03 0.88448486E-03 0.13880000E+01 0.26526611E-02 0.88449762E-03 0.88406582E-03 0.88409771E-03 0.13882000E+01 0.26515004E-02 0.88411058E-03 0.88367898E-03 0.88371086E-03 0.13884000E+01 0.26503406E-02 0.88372385E-03 0.88329244E-03 0.88332431E-03 0.13886000E+01 0.26491817E-02 0.88333743E-03 0.88290621E-03 0.88293807E-03 0.13888000E+01 0.26480237E-02 0.88295130E-03 0.88252027E-03 0.88255213E-03 0.13890000E+01 0.26468666E-02 0.88256548E-03 0.88213464E-03 0.88216649E-03 0.13892000E+01 0.26457104E-02 0.88217995E-03 0.88174931E-03 0.88178115E-03 0.13894000E+01 0.26445551E-02 0.88179473E-03 0.88136428E-03 0.88139611E-03 0.13896000E+01 0.26434007E-02 0.88140981E-03 0.88097955E-03 0.88101137E-03 0.13898000E+01 0.26422473E-02 0.88102519E-03 0.88059513E-03 0.88062693E-03 0.13900000E+01 0.26410947E-02 0.88064087E-03 0.88021100E-03 0.88024280E-03 0.13902000E+01 0.26399430E-02 0.88025685E-03 0.87982717E-03 0.87985896E-03 0.13904000E+01 0.26387922E-02 0.87987313E-03 0.87944364E-03 0.87947542E-03 0.13906000E+01 0.26376423E-02 0.87948971E-03 0.87906041E-03 0.87909218E-03 0.13908000E+01 0.26364933E-02 0.87910659E-03 0.87867748E-03 0.87870924E-03 0.13910000E+01 0.26353452E-02 0.87872377E-03 0.87829485E-03 0.87832660E-03 0.13912000E+01 0.26341980E-02 0.87834124E-03 0.87791251E-03 0.87794426E-03 0.13914000E+01 0.26330517E-02 0.87795901E-03 0.87753048E-03 0.87756221E-03 0.13916000E+01 0.26319063E-02 0.87757708E-03 0.87714874E-03 0.87718047E-03 0.13918000E+01 0.26307618E-02 0.87719545E-03 0.87676729E-03 0.87679901E-03 0.13920000E+01 0.26296181E-02 0.87681412E-03 0.87638615E-03 0.87641786E-03 0.13922000E+01 0.26284754E-02 0.87643308E-03 0.87600530E-03 0.87603700E-03 0.13924000E+01 0.26273335E-02 0.87605233E-03 0.87562475E-03 0.87565644E-03 0.13926000E+01 0.26261925E-02 0.87567189E-03 0.87524449E-03 0.87527617E-03 0.13928000E+01 0.26250525E-02 0.87529173E-03 0.87486453E-03 0.87489620E-03 0.13930000E+01 0.26239133E-02 0.87491188E-03 0.87448486E-03 0.87451653E-03 0.13932000E+01 0.26227750E-02 0.87453232E-03 0.87410549E-03 0.87413715E-03 0.13934000E+01 0.26216375E-02 0.87415305E-03 0.87372641E-03 0.87375806E-03 0.13936000E+01 0.26205010E-02 0.87377408E-03 0.87334763E-03 0.87337927E-03 0.13938000E+01 0.26193653E-02 0.87339540E-03 0.87296914E-03 0.87300077E-03 0.13940000E+01 0.26182305E-02 0.87301702E-03 0.87259094E-03 0.87262257E-03 0.13942000E+01 0.26170966E-02 0.87263892E-03 0.87221304E-03 0.87224465E-03 0.13944000E+01 0.26159636E-02 0.87226113E-03 0.87183543E-03 0.87186704E-03 0.13946000E+01 0.26148314E-02 0.87188362E-03 0.87145811E-03 0.87148971E-03 0.13948000E+01 0.26137002E-02 0.87150641E-03 0.87108108E-03 0.87111268E-03 0.13950000E+01 0.26125698E-02 0.87112949E-03 0.87070435E-03 0.87073593E-03 0.13952000E+01 0.26114402E-02 0.87075286E-03 0.87032791E-03 0.87035948E-03 0.13954000E+01 0.26103116E-02 0.87037652E-03 0.86995176E-03 0.86998332E-03 0.13956000E+01 0.26091838E-02 0.87000047E-03 0.86957590E-03 0.86960746E-03 0.13958000E+01 0.26080569E-02 0.86962472E-03 0.86920033E-03 0.86923188E-03 0.13960000E+01 0.26069309E-02 0.86924925E-03 0.86882505E-03 0.86885659E-03 0.13962000E+01 0.26058057E-02 0.86887407E-03 0.86845006E-03 0.86848159E-03 0.13964000E+01 0.26046814E-02 0.86849919E-03 0.86807536E-03 0.86810689E-03 0.13966000E+01 0.26035580E-02 0.86812459E-03 0.86770095E-03 0.86773247E-03 0.13968000E+01 0.26024355E-02 0.86775029E-03 0.86732683E-03 0.86735834E-03 0.13970000E+01 0.26013138E-02 0.86737627E-03 0.86695300E-03 0.86698450E-03 0.13972000E+01 0.26001929E-02 0.86700254E-03 0.86657946E-03 0.86661095E-03 0.13974000E+01 0.25990730E-02 0.86662910E-03 0.86620620E-03 0.86623768E-03 0.13976000E+01 0.25979539E-02 0.86625594E-03 0.86583324E-03 0.86586471E-03 0.13978000E+01 0.25968357E-02 0.86588308E-03 0.86546056E-03 0.86549202E-03 0.13980000E+01 0.25957183E-02 0.86551050E-03 0.86508816E-03 0.86511962E-03 0.13982000E+01 0.25946018E-02 0.86513821E-03 0.86471606E-03 0.86474750E-03 0.13984000E+01 0.25934861E-02 0.86476620E-03 0.86434424E-03 0.86437567E-03 0.13986000E+01 0.25923713E-02 0.86439448E-03 0.86397270E-03 0.86400413E-03 0.13988000E+01 0.25912574E-02 0.86402305E-03 0.86360146E-03 0.86363288E-03 0.13990000E+01 0.25901443E-02 0.86365190E-03 0.86323050E-03 0.86326191E-03 0.13992000E+01 0.25890321E-02 0.86328104E-03 0.86285982E-03 0.86289122E-03 0.13994000E+01 0.25879207E-02 0.86291047E-03 0.86248943E-03 0.86252082E-03 0.13996000E+01 0.25868102E-02 0.86254018E-03 0.86211932E-03 0.86215071E-03 0.13998000E+01 0.25857005E-02 0.86217017E-03 0.86174950E-03 0.86178087E-03 0.14000000E+01 0.25845917E-02 0.86180045E-03 0.86137996E-03 0.86141133E-03 0.14002000E+01 0.25834838E-02 0.86143101E-03 0.86101071E-03 0.86104206E-03 0.14004000E+01 0.25823767E-02 0.86106185E-03 0.86064173E-03 0.86067308E-03 0.14006000E+01 0.25812704E-02 0.86069298E-03 0.86027305E-03 0.86030439E-03 0.14008000E+01 0.25801650E-02 0.86032439E-03 0.85990464E-03 0.85993597E-03 0.14010000E+01 0.25790604E-02 0.85995609E-03 0.85953652E-03 0.85956784E-03 0.14012000E+01 0.25779567E-02 0.85958806E-03 0.85916868E-03 0.85919999E-03 0.14014000E+01 0.25768539E-02 0.85922032E-03 0.85880112E-03 0.85883243E-03 0.14016000E+01 0.25757518E-02 0.85885286E-03 0.85843384E-03 0.85846514E-03 0.14018000E+01 0.25746507E-02 0.85848568E-03 0.85806685E-03 0.85809814E-03 0.14020000E+01 0.25735503E-02 0.85811878E-03 0.85770013E-03 0.85773141E-03 0.14022000E+01 0.25724508E-02 0.85775217E-03 0.85733370E-03 0.85736497E-03 0.14024000E+01 0.25713522E-02 0.85738583E-03 0.85696754E-03 0.85699881E-03 0.14026000E+01 0.25702544E-02 0.85701978E-03 0.85660167E-03 0.85663293E-03 0.14028000E+01 0.25691574E-02 0.85665400E-03 0.85623608E-03 0.85626732E-03 0.14030000E+01 0.25680613E-02 0.85628850E-03 0.85587076E-03 0.85590200E-03 0.14032000E+01 0.25669660E-02 0.85592329E-03 0.85550573E-03 0.85553696E-03 0.14034000E+01 0.25658715E-02 0.85555835E-03 0.85514097E-03 0.85517219E-03 0.14036000E+01 0.25647779E-02 0.85519369E-03 0.85477649E-03 0.85480771E-03 0.14038000E+01 0.25636851E-02 0.85482931E-03 0.85441229E-03 0.85444350E-03 0.14040000E+01 0.25625931E-02 0.85446520E-03 0.85404837E-03 0.85407957E-03 0.14042000E+01 0.25615020E-02 0.85410138E-03 0.85368473E-03 0.85371591E-03 0.14044000E+01 0.25604117E-02 0.85373783E-03 0.85332136E-03 0.85335254E-03 0.14046000E+01 0.25593223E-02 0.85337456E-03 0.85295827E-03 0.85298944E-03 0.14048000E+01 0.25582336E-02 0.85301157E-03 0.85259546E-03 0.85262662E-03 0.14050000E+01 0.25571458E-02 0.85264885E-03 0.85223292E-03 0.85226408E-03 0.14052000E+01 0.25560589E-02 0.85228641E-03 0.85187066E-03 0.85190181E-03 0.14054000E+01 0.25549727E-02 0.85192425E-03 0.85150868E-03 0.85153981E-03 0.14056000E+01 0.25538874E-02 0.85156236E-03 0.85114697E-03 0.85117810E-03 0.14058000E+01 0.25528029E-02 0.85120074E-03 0.85078554E-03 0.85081666E-03 0.14060000E+01 0.25517193E-02 0.85083940E-03 0.85042438E-03 0.85045549E-03 0.14062000E+01 0.25506364E-02 0.85047834E-03 0.85006349E-03 0.85009460E-03 0.14064000E+01 0.25495544E-02 0.85011755E-03 0.84970288E-03 0.84973398E-03 0.14066000E+01 0.25484732E-02 0.84975704E-03 0.84934255E-03 0.84937364E-03 0.14068000E+01 0.25473929E-02 0.84939680E-03 0.84898249E-03 0.84901357E-03 0.14070000E+01 0.25463133E-02 0.84903683E-03 0.84862270E-03 0.84865377E-03 0.14072000E+01 0.25452346E-02 0.84867714E-03 0.84826319E-03 0.84829425E-03 0.14074000E+01 0.25441567E-02 0.84831772E-03 0.84790394E-03 0.84793500E-03 0.14076000E+01 0.25430796E-02 0.84795857E-03 0.84754497E-03 0.84757602E-03 0.14078000E+01 0.25420033E-02 0.84759969E-03 0.84718628E-03 0.84721731E-03 0.14080000E+01 0.25409278E-02 0.84724109E-03 0.84682785E-03 0.84685888E-03 0.14082000E+01 0.25398532E-02 0.84688276E-03 0.84646970E-03 0.84650072E-03 0.14084000E+01 0.25387793E-02 0.84652470E-03 0.84611182E-03 0.84614283E-03 0.14086000E+01 0.25377063E-02 0.84616691E-03 0.84575421E-03 0.84578521E-03 0.14088000E+01 0.25366341E-02 0.84580939E-03 0.84539687E-03 0.84542786E-03 0.14090000E+01 0.25355627E-02 0.84545214E-03 0.84503980E-03 0.84507078E-03 0.14092000E+01 0.25344921E-02 0.84509517E-03 0.84468300E-03 0.84471398E-03 0.14094000E+01 0.25334224E-02 0.84473846E-03 0.84432647E-03 0.84435744E-03 0.14096000E+01 0.25323534E-02 0.84438203E-03 0.84397021E-03 0.84400117E-03 0.14098000E+01 0.25312853E-02 0.84402586E-03 0.84361422E-03 0.84364517E-03 0.14100000E+01 0.25302179E-02 0.84366996E-03 0.84325850E-03 0.84328945E-03 0.14102000E+01 0.25291514E-02 0.84331433E-03 0.84290305E-03 0.84293399E-03 0.14104000E+01 0.25280856E-02 0.84295897E-03 0.84254787E-03 0.84257879E-03 0.14106000E+01 0.25270207E-02 0.84260388E-03 0.84219295E-03 0.84222387E-03 0.14108000E+01 0.25259566E-02 0.84224906E-03 0.84183831E-03 0.84186922E-03 0.14110000E+01 0.25248933E-02 0.84189450E-03 0.84148393E-03 0.84151483E-03 0.14112000E+01 0.25238307E-02 0.84154021E-03 0.84112982E-03 0.84116071E-03 0.14114000E+01 0.25227690E-02 0.84118619E-03 0.84077597E-03 0.84080686E-03 0.14116000E+01 0.25217081E-02 0.84083244E-03 0.84042240E-03 0.84045327E-03 0.14118000E+01 0.25206480E-02 0.84047895E-03 0.84006908E-03 0.84009995E-03 0.14120000E+01 0.25195887E-02 0.84012573E-03 0.83971604E-03 0.83974690E-03 0.14122000E+01 0.25185301E-02 0.83977278E-03 0.83936326E-03 0.83939411E-03 0.14124000E+01 0.25174724E-02 0.83942009E-03 0.83901075E-03 0.83904159E-03 0.14126000E+01 0.25164155E-02 0.83906767E-03 0.83865850E-03 0.83868933E-03 0.14128000E+01 0.25153594E-02 0.83871551E-03 0.83830652E-03 0.83833734E-03 0.14130000E+01 0.25143040E-02 0.83836362E-03 0.83795480E-03 0.83798562E-03 0.14132000E+01 0.25132495E-02 0.83801199E-03 0.83760335E-03 0.83763415E-03 0.14134000E+01 0.25121957E-02 0.83766062E-03 0.83725216E-03 0.83728296E-03 0.14136000E+01 0.25111428E-02 0.83730953E-03 0.83690123E-03 0.83693202E-03 0.14138000E+01 0.25100906E-02 0.83695869E-03 0.83655057E-03 0.83658136E-03 0.14140000E+01 0.25090392E-02 0.83660812E-03 0.83620018E-03 0.83623095E-03 0.14142000E+01 0.25079887E-02 0.83625781E-03 0.83585004E-03 0.83588081E-03 0.14144000E+01 0.25069389E-02 0.83590776E-03 0.83550017E-03 0.83553093E-03 0.14146000E+01 0.25058899E-02 0.83555798E-03 0.83515056E-03 0.83518131E-03 0.14148000E+01 0.25048416E-02 0.83520846E-03 0.83480121E-03 0.83483196E-03 0.14150000E+01 0.25037942E-02 0.83485920E-03 0.83445213E-03 0.83448286E-03 0.14152000E+01 0.25027475E-02 0.83451021E-03 0.83410331E-03 0.83413403E-03 0.14154000E+01 0.25017017E-02 0.83416147E-03 0.83375475E-03 0.83378546E-03 0.14156000E+01 0.25006566E-02 0.83381300E-03 0.83340645E-03 0.83343715E-03 0.14158000E+01 0.24996123E-02 0.83346479E-03 0.83305841E-03 0.83308911E-03 0.14160000E+01 0.24985688E-02 0.83311683E-03 0.83271063E-03 0.83274132E-03 0.14162000E+01 0.24975260E-02 0.83276914E-03 0.83236311E-03 0.83239379E-03 0.14164000E+01 0.24964841E-02 0.83242171E-03 0.83201585E-03 0.83204653E-03 0.14166000E+01 0.24954429E-02 0.83207454E-03 0.83166886E-03 0.83169952E-03 0.14168000E+01 0.24944025E-02 0.83172763E-03 0.83132212E-03 0.83135278E-03 0.14170000E+01 0.24933629E-02 0.83138098E-03 0.83097564E-03 0.83100629E-03 0.14172000E+01 0.24923241E-02 0.83103459E-03 0.83062942E-03 0.83066006E-03 0.14174000E+01 0.24912860E-02 0.83068845E-03 0.83028346E-03 0.83031409E-03 0.14176000E+01 0.24902487E-02 0.83034258E-03 0.82993775E-03 0.82996838E-03 0.14178000E+01 0.24892122E-02 0.82999696E-03 0.82959231E-03 0.82962293E-03 0.14180000E+01 0.24881765E-02 0.82965160E-03 0.82924712E-03 0.82927773E-03 0.14182000E+01 0.24871415E-02 0.82930650E-03 0.82890219E-03 0.82893279E-03 0.14184000E+01 0.24861073E-02 0.82896166E-03 0.82855752E-03 0.82858811E-03 0.14186000E+01 0.24850739E-02 0.82861707E-03 0.82821311E-03 0.82824369E-03 0.14188000E+01 0.24840412E-02 0.82827275E-03 0.82786895E-03 0.82789953E-03 0.14190000E+01 0.24830093E-02 0.82792867E-03 0.82752505E-03 0.82755562E-03 0.14192000E+01 0.24819782E-02 0.82758486E-03 0.82718141E-03 0.82721196E-03 0.14194000E+01 0.24809479E-02 0.82724130E-03 0.82683802E-03 0.82686857E-03 0.14196000E+01 0.24799183E-02 0.82689799E-03 0.82649488E-03 0.82652543E-03 0.14198000E+01 0.24788895E-02 0.82655495E-03 0.82615201E-03 0.82618254E-03 0.14200000E+01 0.24778614E-02 0.82621215E-03 0.82580938E-03 0.82583991E-03 0.14202000E+01 0.24768342E-02 0.82586962E-03 0.82546702E-03 0.82549753E-03 0.14204000E+01 0.24758076E-02 0.82552733E-03 0.82512490E-03 0.82515541E-03 0.14206000E+01 0.24747819E-02 0.82518530E-03 0.82478305E-03 0.82481355E-03 0.14208000E+01 0.24737569E-02 0.82484353E-03 0.82444144E-03 0.82447193E-03 0.14210000E+01 0.24727327E-02 0.82450201E-03 0.82410009E-03 0.82413058E-03 0.14212000E+01 0.24717092E-02 0.82416074E-03 0.82375900E-03 0.82378947E-03 0.14214000E+01 0.24706865E-02 0.82381973E-03 0.82341815E-03 0.82344862E-03 0.14216000E+01 0.24696646E-02 0.82347897E-03 0.82307756E-03 0.82310802E-03 0.14218000E+01 0.24686434E-02 0.82313846E-03 0.82273722E-03 0.82276768E-03 0.14220000E+01 0.24676229E-02 0.82279821E-03 0.82239714E-03 0.82242758E-03 0.14222000E+01 0.24666033E-02 0.82245821E-03 0.82205731E-03 0.82208774E-03 0.14224000E+01 0.24655843E-02 0.82211846E-03 0.82171773E-03 0.82174815E-03 0.14226000E+01 0.24645662E-02 0.82177896E-03 0.82137840E-03 0.82140882E-03 0.14228000E+01 0.24635488E-02 0.82143972E-03 0.82103932E-03 0.82106973E-03 0.14230000E+01 0.24625321E-02 0.82110072E-03 0.82070050E-03 0.82073090E-03 0.14232000E+01 0.24615162E-02 0.82076198E-03 0.82036192E-03 0.82039231E-03 0.14234000E+01 0.24605011E-02 0.82042348E-03 0.82002360E-03 0.82005398E-03 0.14236000E+01 0.24594867E-02 0.82008524E-03 0.81968552E-03 0.81971590E-03 0.14238000E+01 0.24584730E-02 0.81974725E-03 0.81934770E-03 0.81937807E-03 0.14240000E+01 0.24574601E-02 0.81940951E-03 0.81901012E-03 0.81904049E-03 0.14242000E+01 0.24564480E-02 0.81907202E-03 0.81867280E-03 0.81870315E-03 0.14244000E+01 0.24554366E-02 0.81873477E-03 0.81833573E-03 0.81836607E-03 0.14246000E+01 0.24544259E-02 0.81839778E-03 0.81799890E-03 0.81802924E-03 0.14248000E+01 0.24534160E-02 0.81806104E-03 0.81766232E-03 0.81769265E-03 0.14250000E+01 0.24524069E-02 0.81772454E-03 0.81732600E-03 0.81735632E-03 0.14252000E+01 0.24513984E-02 0.81738829E-03 0.81698992E-03 0.81702023E-03 0.14254000E+01 0.24503908E-02 0.81705230E-03 0.81665408E-03 0.81668439E-03 0.14256000E+01 0.24493838E-02 0.81671655E-03 0.81631850E-03 0.81634880E-03 0.14258000E+01 0.24483777E-02 0.81638104E-03 0.81598316E-03 0.81601345E-03 0.14260000E+01 0.24473722E-02 0.81604579E-03 0.81564808E-03 0.81567835E-03 0.14262000E+01 0.24463675E-02 0.81571078E-03 0.81531323E-03 0.81534350E-03 0.14264000E+01 0.24453636E-02 0.81537602E-03 0.81497864E-03 0.81500890E-03 0.14266000E+01 0.24443603E-02 0.81504150E-03 0.81464429E-03 0.81467454E-03 0.14268000E+01 0.24433579E-02 0.81470723E-03 0.81431019E-03 0.81434043E-03 0.14270000E+01 0.24423561E-02 0.81437321E-03 0.81397633E-03 0.81400657E-03 0.14272000E+01 0.24413551E-02 0.81403943E-03 0.81364272E-03 0.81367295E-03 0.14274000E+01 0.24403548E-02 0.81370590E-03 0.81330936E-03 0.81333958E-03 0.14276000E+01 0.24393553E-02 0.81337262E-03 0.81297624E-03 0.81300645E-03 0.14278000E+01 0.24383565E-02 0.81303958E-03 0.81264336E-03 0.81267357E-03 0.14280000E+01 0.24373584E-02 0.81270678E-03 0.81231073E-03 0.81234093E-03 0.14282000E+01 0.24363611E-02 0.81237423E-03 0.81197835E-03 0.81200853E-03 0.14284000E+01 0.24353645E-02 0.81204192E-03 0.81164620E-03 0.81167639E-03 0.14286000E+01 0.24343686E-02 0.81170986E-03 0.81131431E-03 0.81134448E-03 0.14288000E+01 0.24333735E-02 0.81137804E-03 0.81098265E-03 0.81101282E-03 0.14290000E+01 0.24323791E-02 0.81104647E-03 0.81065124E-03 0.81068140E-03 0.14292000E+01 0.24313854E-02 0.81071514E-03 0.81032008E-03 0.81035023E-03 0.14294000E+01 0.24303925E-02 0.81038405E-03 0.80998915E-03 0.81001929E-03 0.14296000E+01 0.24294003E-02 0.81005320E-03 0.80965847E-03 0.80968860E-03 0.14298000E+01 0.24284088E-02 0.80972260E-03 0.80932803E-03 0.80935816E-03 0.14300000E+01 0.24274180E-02 0.80939224E-03 0.80899784E-03 0.80902795E-03 0.14302000E+01 0.24264280E-02 0.80906212E-03 0.80866788E-03 0.80869799E-03 0.14304000E+01 0.24254387E-02 0.80873224E-03 0.80833817E-03 0.80836827E-03 0.14306000E+01 0.24244501E-02 0.80840261E-03 0.80800870E-03 0.80803879E-03 0.14308000E+01 0.24234622E-02 0.80807321E-03 0.80767947E-03 0.80770955E-03 0.14310000E+01 0.24224751E-02 0.80774406E-03 0.80735048E-03 0.80738055E-03 0.14312000E+01 0.24214887E-02 0.80741515E-03 0.80702173E-03 0.80705180E-03 0.14314000E+01 0.24205030E-02 0.80708648E-03 0.80669322E-03 0.80672328E-03 0.14316000E+01 0.24195180E-02 0.80675805E-03 0.80636495E-03 0.80639501E-03 0.14318000E+01 0.24185338E-02 0.80642986E-03 0.80603693E-03 0.80606697E-03 0.14320000E+01 0.24175502E-02 0.80610191E-03 0.80570914E-03 0.80573917E-03 0.14322000E+01 0.24165674E-02 0.80577419E-03 0.80538159E-03 0.80541162E-03 0.14324000E+01 0.24155853E-02 0.80544672E-03 0.80505428E-03 0.80508430E-03 0.14326000E+01 0.24146039E-02 0.80511949E-03 0.80472721E-03 0.80475722E-03 0.14328000E+01 0.24136233E-02 0.80479249E-03 0.80440038E-03 0.80443038E-03 0.14330000E+01 0.24126433E-02 0.80446574E-03 0.80407379E-03 0.80410378E-03 0.14332000E+01 0.24116641E-02 0.80413922E-03 0.80374743E-03 0.80377742E-03 0.14334000E+01 0.24106855E-02 0.80381294E-03 0.80342131E-03 0.80345129E-03 0.14336000E+01 0.24097077E-02 0.80348690E-03 0.80309543E-03 0.80312541E-03 0.14338000E+01 0.24087306E-02 0.80316110E-03 0.80276979E-03 0.80279976E-03 0.14340000E+01 0.24077543E-02 0.80283553E-03 0.80244439E-03 0.80247434E-03 0.14342000E+01 0.24067786E-02 0.80251020E-03 0.80211922E-03 0.80214917E-03 0.14344000E+01 0.24058036E-02 0.80218511E-03 0.80179429E-03 0.80182423E-03 0.14346000E+01 0.24048294E-02 0.80186025E-03 0.80146960E-03 0.80149953E-03 0.14348000E+01 0.24038558E-02 0.80153563E-03 0.80114514E-03 0.80117506E-03 0.14350000E+01 0.24028830E-02 0.80121125E-03 0.80082092E-03 0.80085083E-03 0.14352000E+01 0.24019109E-02 0.80088710E-03 0.80049693E-03 0.80052684E-03 0.14354000E+01 0.24009395E-02 0.80056319E-03 0.80017318E-03 0.80020308E-03 0.14356000E+01 0.23999687E-02 0.80023952E-03 0.79984966E-03 0.79987956E-03 0.14358000E+01 0.23989987E-02 0.79991608E-03 0.79952638E-03 0.79955627E-03 0.14360000E+01 0.23980294E-02 0.79959287E-03 0.79920334E-03 0.79923321E-03 0.14362000E+01 0.23970608E-02 0.79926990E-03 0.79888053E-03 0.79891040E-03 0.14364000E+01 0.23960929E-02 0.79894716E-03 0.79855795E-03 0.79858781E-03 0.14366000E+01 0.23951257E-02 0.79862466E-03 0.79823561E-03 0.79826546E-03 0.14368000E+01 0.23941592E-02 0.79830239E-03 0.79791350E-03 0.79794334E-03 0.14370000E+01 0.23931934E-02 0.79798035E-03 0.79759163E-03 0.79762146E-03 0.14372000E+01 0.23922283E-02 0.79765855E-03 0.79726998E-03 0.79729981E-03 0.14374000E+01 0.23912640E-02 0.79733699E-03 0.79694858E-03 0.79697840E-03 0.14376000E+01 0.23903003E-02 0.79701565E-03 0.79662740E-03 0.79665721E-03 0.14378000E+01 0.23893373E-02 0.79669455E-03 0.79630646E-03 0.79633626E-03 0.14380000E+01 0.23883750E-02 0.79637368E-03 0.79598575E-03 0.79601554E-03 0.14382000E+01 0.23874134E-02 0.79605304E-03 0.79566527E-03 0.79569506E-03 0.14384000E+01 0.23864525E-02 0.79573263E-03 0.79534502E-03 0.79537480E-03 0.14386000E+01 0.23854922E-02 0.79541246E-03 0.79502501E-03 0.79505478E-03 0.14388000E+01 0.23845327E-02 0.79509252E-03 0.79470523E-03 0.79473499E-03 0.14390000E+01 0.23835739E-02 0.79477281E-03 0.79438567E-03 0.79441543E-03 0.14392000E+01 0.23826158E-02 0.79445333E-03 0.79406635E-03 0.79409610E-03 0.14394000E+01 0.23816583E-02 0.79413408E-03 0.79374726E-03 0.79377700E-03 0.14396000E+01 0.23807016E-02 0.79381506E-03 0.79342840E-03 0.79345813E-03 0.14398000E+01 0.23797455E-02 0.79349627E-03 0.79310977E-03 0.79313950E-03 0.14400000E+01 0.23787902E-02 0.79317772E-03 0.79279137E-03 0.79282109E-03 0.14402000E+01 0.23778355E-02 0.79285939E-03 0.79247321E-03 0.79250291E-03 0.14404000E+01 0.23768815E-02 0.79254129E-03 0.79215527E-03 0.79218497E-03 0.14406000E+01 0.23759282E-02 0.79222342E-03 0.79183756E-03 0.79186725E-03 0.14408000E+01 0.23749756E-02 0.79190578E-03 0.79152007E-03 0.79154976E-03 0.14410000E+01 0.23740237E-02 0.79158837E-03 0.79120282E-03 0.79123250E-03 0.14412000E+01 0.23730725E-02 0.79127119E-03 0.79088580E-03 0.79091547E-03 0.14414000E+01 0.23721219E-02 0.79095424E-03 0.79056900E-03 0.79059866E-03 0.14416000E+01 0.23711720E-02 0.79063751E-03 0.79025243E-03 0.79028209E-03 0.14418000E+01 0.23702229E-02 0.79032102E-03 0.78993610E-03 0.78996574E-03 0.14420000E+01 0.23692744E-02 0.79000475E-03 0.78961998E-03 0.78964962E-03 0.14422000E+01 0.23683265E-02 0.78968871E-03 0.78930410E-03 0.78933373E-03 0.14424000E+01 0.23673794E-02 0.78937289E-03 0.78898844E-03 0.78901806E-03 0.14426000E+01 0.23664329E-02 0.78905731E-03 0.78867301E-03 0.78870263E-03 0.14428000E+01 0.23654872E-02 0.78874195E-03 0.78835781E-03 0.78838741E-03 0.14430000E+01 0.23645421E-02 0.78842681E-03 0.78804283E-03 0.78807243E-03 0.14432000E+01 0.23635977E-02 0.78811191E-03 0.78772808E-03 0.78775767E-03 0.14434000E+01 0.23626539E-02 0.78779723E-03 0.78741356E-03 0.78744314E-03 0.14436000E+01 0.23617109E-02 0.78748277E-03 0.78709926E-03 0.78712883E-03 0.14438000E+01 0.23607685E-02 0.78716854E-03 0.78678519E-03 0.78681475E-03 0.14440000E+01 0.23598268E-02 0.78685454E-03 0.78647134E-03 0.78650090E-03 0.14442000E+01 0.23588857E-02 0.78654076E-03 0.78615772E-03 0.78618727E-03 0.14444000E+01 0.23579454E-02 0.78622721E-03 0.78584432E-03 0.78587386E-03 0.14446000E+01 0.23570057E-02 0.78591388E-03 0.78553115E-03 0.78556068E-03 0.14448000E+01 0.23560667E-02 0.78560078E-03 0.78521820E-03 0.78524773E-03 0.14450000E+01 0.23551284E-02 0.78528790E-03 0.78490548E-03 0.78493500E-03 0.14452000E+01 0.23541907E-02 0.78497524E-03 0.78459298E-03 0.78462249E-03 0.14454000E+01 0.23532537E-02 0.78466281E-03 0.78428070E-03 0.78431020E-03 0.14456000E+01 0.23523174E-02 0.78435061E-03 0.78396865E-03 0.78399814E-03 0.14458000E+01 0.23513818E-02 0.78403862E-03 0.78365682E-03 0.78368631E-03 0.14460000E+01 0.23504468E-02 0.78372686E-03 0.78334522E-03 0.78337469E-03 0.14462000E+01 0.23495125E-02 0.78341532E-03 0.78303383E-03 0.78306330E-03 0.14464000E+01 0.23485788E-02 0.78310401E-03 0.78272267E-03 0.78275214E-03 0.14466000E+01 0.23476458E-02 0.78279292E-03 0.78241173E-03 0.78244119E-03 0.14468000E+01 0.23467135E-02 0.78248205E-03 0.78210102E-03 0.78213047E-03 0.14470000E+01 0.23457819E-02 0.78217140E-03 0.78179053E-03 0.78181997E-03 0.14472000E+01 0.23448509E-02 0.78186097E-03 0.78148025E-03 0.78150969E-03 0.14474000E+01 0.23439206E-02 0.78155077E-03 0.78117020E-03 0.78119963E-03 0.14476000E+01 0.23429910E-02 0.78124079E-03 0.78086038E-03 0.78088979E-03 0.14478000E+01 0.23420620E-02 0.78093102E-03 0.78055077E-03 0.78058018E-03 0.14480000E+01 0.23411336E-02 0.78062148E-03 0.78024138E-03 0.78027078E-03 0.14482000E+01 0.23402060E-02 0.78031216E-03 0.77993221E-03 0.77996161E-03 0.14484000E+01 0.23392790E-02 0.78000306E-03 0.77962327E-03 0.77965265E-03 0.14486000E+01 0.23383526E-02 0.77969419E-03 0.77931454E-03 0.77934392E-03 0.14488000E+01 0.23374270E-02 0.77938553E-03 0.77900604E-03 0.77903541E-03 0.14490000E+01 0.23365020E-02 0.77907709E-03 0.77869775E-03 0.77872711E-03 0.14492000E+01 0.23355776E-02 0.77876887E-03 0.77838969E-03 0.77841904E-03 0.14494000E+01 0.23346539E-02 0.77846087E-03 0.77808184E-03 0.77811118E-03 0.14496000E+01 0.23337308E-02 0.77815309E-03 0.77777421E-03 0.77780355E-03 0.14498000E+01 0.23328085E-02 0.77784553E-03 0.77746680E-03 0.77749613E-03 0.14500000E+01 0.23318867E-02 0.77753818E-03 0.77715961E-03 0.77718893E-03 0.14502000E+01 0.23309657E-02 0.77723106E-03 0.77685264E-03 0.77688195E-03 0.14504000E+01 0.23300452E-02 0.77692415E-03 0.77654589E-03 0.77657519E-03 0.14506000E+01 0.23291255E-02 0.77661746E-03 0.77623935E-03 0.77626865E-03 0.14508000E+01 0.23282064E-02 0.77631099E-03 0.77593303E-03 0.77596232E-03 0.14510000E+01 0.23272879E-02 0.77600474E-03 0.77562693E-03 0.77565622E-03 0.14512000E+01 0.23263701E-02 0.77569871E-03 0.77532105E-03 0.77535033E-03 0.14514000E+01 0.23254529E-02 0.77539289E-03 0.77501538E-03 0.77504465E-03 0.14516000E+01 0.23245364E-02 0.77508729E-03 0.77470994E-03 0.77473920E-03 0.14518000E+01 0.23236206E-02 0.77478191E-03 0.77440470E-03 0.77443396E-03 0.14520000E+01 0.23227054E-02 0.77447674E-03 0.77409969E-03 0.77412893E-03 0.14522000E+01 0.23217908E-02 0.77417179E-03 0.77379489E-03 0.77382412E-03 0.14524000E+01 0.23208769E-02 0.77386705E-03 0.77349030E-03 0.77351953E-03 0.14526000E+01 0.23199636E-02 0.77356253E-03 0.77318594E-03 0.77321516E-03 0.14528000E+01 0.23190510E-02 0.77325823E-03 0.77288178E-03 0.77291100E-03 0.14530000E+01 0.23181390E-02 0.77295414E-03 0.77257785E-03 0.77260705E-03 0.14532000E+01 0.23172277E-02 0.77265027E-03 0.77227413E-03 0.77230332E-03 0.14534000E+01 0.23163170E-02 0.77234661E-03 0.77197062E-03 0.77199981E-03 0.14536000E+01 0.23154070E-02 0.77204317E-03 0.77166733E-03 0.77169651E-03 0.14538000E+01 0.23144976E-02 0.77173994E-03 0.77136425E-03 0.77139343E-03 0.14540000E+01 0.23135889E-02 0.77143693E-03 0.77106139E-03 0.77109056E-03 0.14542000E+01 0.23126808E-02 0.77113413E-03 0.77075874E-03 0.77078790E-03 0.14544000E+01 0.23117733E-02 0.77083154E-03 0.77045630E-03 0.77048546E-03 0.14546000E+01 0.23108665E-02 0.77052917E-03 0.77015408E-03 0.77018323E-03 0.14548000E+01 0.23099603E-02 0.77022702E-03 0.76985208E-03 0.76988121E-03 0.14550000E+01 0.23090548E-02 0.76992507E-03 0.76955028E-03 0.76957941E-03 0.14552000E+01 0.23081499E-02 0.76962334E-03 0.76924870E-03 0.76927782E-03 0.14554000E+01 0.23072456E-02 0.76932182E-03 0.76894733E-03 0.76897644E-03 0.14556000E+01 0.23063420E-02 0.76902051E-03 0.76864617E-03 0.76867528E-03 0.14558000E+01 0.23054390E-02 0.76871942E-03 0.76834523E-03 0.76837433E-03 0.14560000E+01 0.23045366E-02 0.76841854E-03 0.76804450E-03 0.76807359E-03 0.14562000E+01 0.23036349E-02 0.76811787E-03 0.76774398E-03 0.76777306E-03 0.14564000E+01 0.23027338E-02 0.76781741E-03 0.76744367E-03 0.76747275E-03 0.14566000E+01 0.23018334E-02 0.76751717E-03 0.76714357E-03 0.76717264E-03 0.14568000E+01 0.23009336E-02 0.76721714E-03 0.76684369E-03 0.76687275E-03 0.14570000E+01 0.23000344E-02 0.76691731E-03 0.76654402E-03 0.76657307E-03 0.14572000E+01 0.22991358E-02 0.76661770E-03 0.76624455E-03 0.76627360E-03 0.14574000E+01 0.22982379E-02 0.76631830E-03 0.76594530E-03 0.76597434E-03 0.14576000E+01 0.22973407E-02 0.76601911E-03 0.76564626E-03 0.76567529E-03 0.14578000E+01 0.22964440E-02 0.76572013E-03 0.76534743E-03 0.76537645E-03 0.14580000E+01 0.22955480E-02 0.76542136E-03 0.76504881E-03 0.76507782E-03 0.14582000E+01 0.22946526E-02 0.76512280E-03 0.76475039E-03 0.76477940E-03 0.14584000E+01 0.22937578E-02 0.76482445E-03 0.76445219E-03 0.76448119E-03 0.14586000E+01 0.22928637E-02 0.76452631E-03 0.76415420E-03 0.76418319E-03 0.14588000E+01 0.22919702E-02 0.76422838E-03 0.76385642E-03 0.76388540E-03 0.14590000E+01 0.22910773E-02 0.76393066E-03 0.76355884E-03 0.76358782E-03 0.14592000E+01 0.22901851E-02 0.76363314E-03 0.76326148E-03 0.76329044E-03 0.14594000E+01 0.22892934E-02 0.76333584E-03 0.76296432E-03 0.76299328E-03 0.14596000E+01 0.22884024E-02 0.76303874E-03 0.76266737E-03 0.76269632E-03 0.14598000E+01 0.22875121E-02 0.76274185E-03 0.76237063E-03 0.76239957E-03 0.14600000E+01 0.22866223E-02 0.76244517E-03 0.76207410E-03 0.76210303E-03 0.14602000E+01 0.22857332E-02 0.76214870E-03 0.76177777E-03 0.76180670E-03 0.14604000E+01 0.22848447E-02 0.76185244E-03 0.76148166E-03 0.76151058E-03 0.14606000E+01 0.22839568E-02 0.76155638E-03 0.76118575E-03 0.76121466E-03 0.14608000E+01 0.22830695E-02 0.76126053E-03 0.76089004E-03 0.76091895E-03 0.14610000E+01 0.22821829E-02 0.76096489E-03 0.76059455E-03 0.76062345E-03 0.14612000E+01 0.22812969E-02 0.76066946E-03 0.76029926E-03 0.76032815E-03 0.14614000E+01 0.22804115E-02 0.76037423E-03 0.76000418E-03 0.76003306E-03 0.14616000E+01 0.22795267E-02 0.76007920E-03 0.75970930E-03 0.75973818E-03 0.14618000E+01 0.22786425E-02 0.75978439E-03 0.75941463E-03 0.75944350E-03 0.14620000E+01 0.22777590E-02 0.75948978E-03 0.75912017E-03 0.75914903E-03 0.14622000E+01 0.22768760E-02 0.75919537E-03 0.75882591E-03 0.75885476E-03 0.14624000E+01 0.22759937E-02 0.75890118E-03 0.75853186E-03 0.75856070E-03 0.14626000E+01 0.22751120E-02 0.75860718E-03 0.75823801E-03 0.75826685E-03 0.14628000E+01 0.22742310E-02 0.75831339E-03 0.75794437E-03 0.75797320E-03 0.14630000E+01 0.22733505E-02 0.75801981E-03 0.75765093E-03 0.75767975E-03 0.14632000E+01 0.22724706E-02 0.75772643E-03 0.75735770E-03 0.75738651E-03 0.14634000E+01 0.22715914E-02 0.75743326E-03 0.75706467E-03 0.75709348E-03 0.14636000E+01 0.22707128E-02 0.75714029E-03 0.75677185E-03 0.75680065E-03 0.14638000E+01 0.22698348E-02 0.75684753E-03 0.75647923E-03 0.75650802E-03 0.14640000E+01 0.22689574E-02 0.75655497E-03 0.75618681E-03 0.75621560E-03 0.14642000E+01 0.22680806E-02 0.75626261E-03 0.75589460E-03 0.75592338E-03 0.14644000E+01 0.22672044E-02 0.75597045E-03 0.75560259E-03 0.75563136E-03 0.14646000E+01 0.22663288E-02 0.75567850E-03 0.75531079E-03 0.75533955E-03 0.14648000E+01 0.22654539E-02 0.75538676E-03 0.75501918E-03 0.75504794E-03 0.14650000E+01 0.22645795E-02 0.75509521E-03 0.75472779E-03 0.75475653E-03 0.14652000E+01 0.22637058E-02 0.75480387E-03 0.75443659E-03 0.75446533E-03 0.14654000E+01 0.22628327E-02 0.75451273E-03 0.75414560E-03 0.75417433E-03 0.14656000E+01 0.22619601E-02 0.75422180E-03 0.75385480E-03 0.75388353E-03 0.14658000E+01 0.22610882E-02 0.75393106E-03 0.75356421E-03 0.75359293E-03 0.14660000E+01 0.22602169E-02 0.75364053E-03 0.75327383E-03 0.75330254E-03 0.14662000E+01 0.22593462E-02 0.75335020E-03 0.75298364E-03 0.75301234E-03 0.14664000E+01 0.22584761E-02 0.75306007E-03 0.75269366E-03 0.75272235E-03 0.14666000E+01 0.22576066E-02 0.75277015E-03 0.75240387E-03 0.75243256E-03 0.14668000E+01 0.22567377E-02 0.75248042E-03 0.75211429E-03 0.75214297E-03 0.14670000E+01 0.22558694E-02 0.75219090E-03 0.75182491E-03 0.75185358E-03 0.14672000E+01 0.22550017E-02 0.75190157E-03 0.75153573E-03 0.75156439E-03 0.14674000E+01 0.22541346E-02 0.75161245E-03 0.75124675E-03 0.75127541E-03 0.14676000E+01 0.22532681E-02 0.75132353E-03 0.75095797E-03 0.75098662E-03 0.14678000E+01 0.22524022E-02 0.75103480E-03 0.75066939E-03 0.75069803E-03 0.14680000E+01 0.22515369E-02 0.75074628E-03 0.75038101E-03 0.75040965E-03 0.14682000E+01 0.22506722E-02 0.75045796E-03 0.75009283E-03 0.75012146E-03 0.14684000E+01 0.22498082E-02 0.75016984E-03 0.74980485E-03 0.74983347E-03 0.14686000E+01 0.22489447E-02 0.74988191E-03 0.74951707E-03 0.74954568E-03 0.14688000E+01 0.22480818E-02 0.74959419E-03 0.74922949E-03 0.74925809E-03 0.14690000E+01 0.22472195E-02 0.74930666E-03 0.74894211E-03 0.74897070E-03 0.14692000E+01 0.22463578E-02 0.74901934E-03 0.74865492E-03 0.74868351E-03 0.14694000E+01 0.22454967E-02 0.74873221E-03 0.74836794E-03 0.74839652E-03 0.14696000E+01 0.22446362E-02 0.74844528E-03 0.74808115E-03 0.74810972E-03 0.14698000E+01 0.22437762E-02 0.74815855E-03 0.74779456E-03 0.74782313E-03 0.14700000E+01 0.22429169E-02 0.74787201E-03 0.74750817E-03 0.74753673E-03 0.14702000E+01 0.22420582E-02 0.74758568E-03 0.74722198E-03 0.74725053E-03 0.14704000E+01 0.22412000E-02 0.74729954E-03 0.74693598E-03 0.74696453E-03 0.14706000E+01 0.22403425E-02 0.74701360E-03 0.74665018E-03 0.74667872E-03 0.14708000E+01 0.22394856E-02 0.74672786E-03 0.74636458E-03 0.74639311E-03 0.14710000E+01 0.22386292E-02 0.74644231E-03 0.74607918E-03 0.74610770E-03 0.14712000E+01 0.22377734E-02 0.74615696E-03 0.74579397E-03 0.74582249E-03 0.14714000E+01 0.22369182E-02 0.74587181E-03 0.74550896E-03 0.74553747E-03 0.14716000E+01 0.22360636E-02 0.74558686E-03 0.74522415E-03 0.74525265E-03 0.14718000E+01 0.22352096E-02 0.74530210E-03 0.74493953E-03 0.74496802E-03 0.14720000E+01 0.22343562E-02 0.74501753E-03 0.74465511E-03 0.74468359E-03 0.14722000E+01 0.22335034E-02 0.74473317E-03 0.74437088E-03 0.74439936E-03 0.14724000E+01 0.22326512E-02 0.74444900E-03 0.74408685E-03 0.74411532E-03 0.14726000E+01 0.22317995E-02 0.74416502E-03 0.74380301E-03 0.74383148E-03 0.14728000E+01 0.22309484E-02 0.74388124E-03 0.74351938E-03 0.74354783E-03 0.14730000E+01 0.22300980E-02 0.74359765E-03 0.74323593E-03 0.74326438E-03 0.14732000E+01 0.22292481E-02 0.74331426E-03 0.74295268E-03 0.74298112E-03 0.14734000E+01 0.22283988E-02 0.74303107E-03 0.74266963E-03 0.74269806E-03 0.14736000E+01 0.22275500E-02 0.74274807E-03 0.74238677E-03 0.74241519E-03 0.14738000E+01 0.22267019E-02 0.74246526E-03 0.74210410E-03 0.74213252E-03 0.14740000E+01 0.22258543E-02 0.74218265E-03 0.74182163E-03 0.74185004E-03 0.14742000E+01 0.22250073E-02 0.74190023E-03 0.74153935E-03 0.74156775E-03 0.14744000E+01 0.22241609E-02 0.74161801E-03 0.74125727E-03 0.74128566E-03 0.14746000E+01 0.22233151E-02 0.74133598E-03 0.74097538E-03 0.74100376E-03 0.14748000E+01 0.22224699E-02 0.74105414E-03 0.74069368E-03 0.74072206E-03 0.14750000E+01 0.22216252E-02 0.74077250E-03 0.74041217E-03 0.74044055E-03 0.14752000E+01 0.22207811E-02 0.74049105E-03 0.74013086E-03 0.74015923E-03 0.14754000E+01 0.22199376E-02 0.74020979E-03 0.73984974E-03 0.73987810E-03 0.14756000E+01 0.22190947E-02 0.73992872E-03 0.73956882E-03 0.73959717E-03 0.14758000E+01 0.22182524E-02 0.73964785E-03 0.73928809E-03 0.73931643E-03 0.14760000E+01 0.22174106E-02 0.73936717E-03 0.73900755E-03 0.73903588E-03 0.14762000E+01 0.22165694E-02 0.73908668E-03 0.73872720E-03 0.73875553E-03 0.14764000E+01 0.22157288E-02 0.73880639E-03 0.73844704E-03 0.73847536E-03 0.14766000E+01 0.22148887E-02 0.73852628E-03 0.73816707E-03 0.73819539E-03 0.14768000E+01 0.22140493E-02 0.73824637E-03 0.73788730E-03 0.73791561E-03 0.14770000E+01 0.22132104E-02 0.73796665E-03 0.73760772E-03 0.73763602E-03 0.14772000E+01 0.22123721E-02 0.73768712E-03 0.73732833E-03 0.73735662E-03 0.14774000E+01 0.22115343E-02 0.73740778E-03 0.73704913E-03 0.73707741E-03 0.14776000E+01 0.22106971E-02 0.73712863E-03 0.73677012E-03 0.73679839E-03 0.14778000E+01 0.22098605E-02 0.73684967E-03 0.73649130E-03 0.73651957E-03 0.14780000E+01 0.22090245E-02 0.73657091E-03 0.73621267E-03 0.73624093E-03 0.14782000E+01 0.22081891E-02 0.73629233E-03 0.73593423E-03 0.73596249E-03 0.14784000E+01 0.22073542E-02 0.73601395E-03 0.73565598E-03 0.73568423E-03 0.14786000E+01 0.22065198E-02 0.73573575E-03 0.73537793E-03 0.73540617E-03 0.14788000E+01 0.22056861E-02 0.73545774E-03 0.73510006E-03 0.73512829E-03 0.14790000E+01 0.22048529E-02 0.73517993E-03 0.73482238E-03 0.73485060E-03 0.14792000E+01 0.22040203E-02 0.73490230E-03 0.73454489E-03 0.73457311E-03 0.14794000E+01 0.22031882E-02 0.73462486E-03 0.73426759E-03 0.73429580E-03 0.14796000E+01 0.22023568E-02 0.73434761E-03 0.73399048E-03 0.73401868E-03 0.14798000E+01 0.22015259E-02 0.73407055E-03 0.73371355E-03 0.73374175E-03 0.14800000E+01 0.22006955E-02 0.73379368E-03 0.73343682E-03 0.73346501E-03 0.14802000E+01 0.21998657E-02 0.73351700E-03 0.73316027E-03 0.73318845E-03 0.14804000E+01 0.21990365E-02 0.73324050E-03 0.73288391E-03 0.73291209E-03 0.14806000E+01 0.21982078E-02 0.73296419E-03 0.73260774E-03 0.73263591E-03 0.14808000E+01 0.21973798E-02 0.73268807E-03 0.73233176E-03 0.73235992E-03 0.14810000E+01 0.21965522E-02 0.73241214E-03 0.73205597E-03 0.73208412E-03 0.14812000E+01 0.21957253E-02 0.73213640E-03 0.73178036E-03 0.73180851E-03 0.14814000E+01 0.21948989E-02 0.73186084E-03 0.73150494E-03 0.73153308E-03 0.14816000E+01 0.21940730E-02 0.73158547E-03 0.73122971E-03 0.73125784E-03 0.14818000E+01 0.21932477E-02 0.73131029E-03 0.73095466E-03 0.73098279E-03 0.14820000E+01 0.21924230E-02 0.73103530E-03 0.73067980E-03 0.73070792E-03 0.14822000E+01 0.21915989E-02 0.73076049E-03 0.73040513E-03 0.73043324E-03 0.14824000E+01 0.21907753E-02 0.73048587E-03 0.73013065E-03 0.73015875E-03 0.14826000E+01 0.21899522E-02 0.73021143E-03 0.72985635E-03 0.72988444E-03 0.14828000E+01 0.21891297E-02 0.72993718E-03 0.72958223E-03 0.72961032E-03 0.14830000E+01 0.21883078E-02 0.72966312E-03 0.72930831E-03 0.72933639E-03 0.14832000E+01 0.21874864E-02 0.72938924E-03 0.72903456E-03 0.72906264E-03 0.14834000E+01 0.21866656E-02 0.72911555E-03 0.72876101E-03 0.72878907E-03 0.14836000E+01 0.21858454E-02 0.72884204E-03 0.72848764E-03 0.72851569E-03 0.14838000E+01 0.21850257E-02 0.72856872E-03 0.72821445E-03 0.72824250E-03 0.14840000E+01 0.21842065E-02 0.72829558E-03 0.72794145E-03 0.72796949E-03 0.14842000E+01 0.21833879E-02 0.72802263E-03 0.72766863E-03 0.72769667E-03 0.14844000E+01 0.21825699E-02 0.72774987E-03 0.72739600E-03 0.72742403E-03 0.14846000E+01 0.21817524E-02 0.72747728E-03 0.72712355E-03 0.72715158E-03 0.14848000E+01 0.21809355E-02 0.72720489E-03 0.72685129E-03 0.72687931E-03 0.14850000E+01 0.21801191E-02 0.72693267E-03 0.72657921E-03 0.72660722E-03 0.14852000E+01 0.21793033E-02 0.72666064E-03 0.72630732E-03 0.72633532E-03 0.14854000E+01 0.21784880E-02 0.72638880E-03 0.72603561E-03 0.72606360E-03 0.14856000E+01 0.21776733E-02 0.72611713E-03 0.72576408E-03 0.72579207E-03 0.14858000E+01 0.21768591E-02 0.72584566E-03 0.72549274E-03 0.72552071E-03 0.14860000E+01 0.21760455E-02 0.72557436E-03 0.72522157E-03 0.72524955E-03 0.14862000E+01 0.21752324E-02 0.72530325E-03 0.72495060E-03 0.72497856E-03 0.14864000E+01 0.21744199E-02 0.72503232E-03 0.72467980E-03 0.72470776E-03 0.14866000E+01 0.21736079E-02 0.72476157E-03 0.72440919E-03 0.72443714E-03 0.14868000E+01 0.21727965E-02 0.72449101E-03 0.72413876E-03 0.72416670E-03 0.14870000E+01 0.21719856E-02 0.72422063E-03 0.72386851E-03 0.72389645E-03 0.14872000E+01 0.21711752E-02 0.72395043E-03 0.72359845E-03 0.72362637E-03 0.14874000E+01 0.21703655E-02 0.72368041E-03 0.72332856E-03 0.72335648E-03 0.14876000E+01 0.21695562E-02 0.72341057E-03 0.72305886E-03 0.72308677E-03 0.14878000E+01 0.21687475E-02 0.72314092E-03 0.72278934E-03 0.72281725E-03 0.14880000E+01 0.21679394E-02 0.72287145E-03 0.72252000E-03 0.72254790E-03 0.14882000E+01 0.21671317E-02 0.72260216E-03 0.72225085E-03 0.72227874E-03 0.14884000E+01 0.21663247E-02 0.72233305E-03 0.72198187E-03 0.72200975E-03 0.14886000E+01 0.21655181E-02 0.72206412E-03 0.72171307E-03 0.72174095E-03 0.14888000E+01 0.21647122E-02 0.72179537E-03 0.72144446E-03 0.72147233E-03 0.14890000E+01 0.21639067E-02 0.72152681E-03 0.72117603E-03 0.72120389E-03 0.14892000E+01 0.21631018E-02 0.72125842E-03 0.72090777E-03 0.72093563E-03 0.14894000E+01 0.21622975E-02 0.72099021E-03 0.72063970E-03 0.72066755E-03 0.14896000E+01 0.21614936E-02 0.72072219E-03 0.72037181E-03 0.72039965E-03 0.14898000E+01 0.21606904E-02 0.72045434E-03 0.72010409E-03 0.72013193E-03 0.14900000E+01 0.21598876E-02 0.72018668E-03 0.71983656E-03 0.71986439E-03 0.14902000E+01 0.21590854E-02 0.71991919E-03 0.71956921E-03 0.71959703E-03 0.14904000E+01 0.21582838E-02 0.71965188E-03 0.71930203E-03 0.71932984E-03 0.14906000E+01 0.21574826E-02 0.71938475E-03 0.71903504E-03 0.71906284E-03 0.14908000E+01 0.21566820E-02 0.71911781E-03 0.71876822E-03 0.71879602E-03 0.14910000E+01 0.21558820E-02 0.71885104E-03 0.71850158E-03 0.71852937E-03 0.14912000E+01 0.21550825E-02 0.71858445E-03 0.71823513E-03 0.71826291E-03 0.14914000E+01 0.21542835E-02 0.71831803E-03 0.71796885E-03 0.71799662E-03 0.14916000E+01 0.21534851E-02 0.71805180E-03 0.71770274E-03 0.71773051E-03 0.14918000E+01 0.21526871E-02 0.71778575E-03 0.71743682E-03 0.71746458E-03 0.14920000E+01 0.21518898E-02 0.71751987E-03 0.71717108E-03 0.71719883E-03 0.14922000E+01 0.21510929E-02 0.71725417E-03 0.71690551E-03 0.71693326E-03 0.14924000E+01 0.21502966E-02 0.71698865E-03 0.71664012E-03 0.71666786E-03 0.14926000E+01 0.21495008E-02 0.71672330E-03 0.71637491E-03 0.71640264E-03 0.14928000E+01 0.21487056E-02 0.71645814E-03 0.71610987E-03 0.71613760E-03 0.14930000E+01 0.21479109E-02 0.71619315E-03 0.71584501E-03 0.71587273E-03 0.14932000E+01 0.21471167E-02 0.71592834E-03 0.71558033E-03 0.71560804E-03 0.14934000E+01 0.21463231E-02 0.71566370E-03 0.71531583E-03 0.71534353E-03 0.14936000E+01 0.21455299E-02 0.71539924E-03 0.71505150E-03 0.71507920E-03 0.14938000E+01 0.21447374E-02 0.71513496E-03 0.71478735E-03 0.71481504E-03 0.14940000E+01 0.21439453E-02 0.71487086E-03 0.71452338E-03 0.71455106E-03 0.14942000E+01 0.21431538E-02 0.71460693E-03 0.71425958E-03 0.71428725E-03 0.14944000E+01 0.21423628E-02 0.71434318E-03 0.71399596E-03 0.71402363E-03 0.14946000E+01 0.21415723E-02 0.71407960E-03 0.71373251E-03 0.71376017E-03 0.14948000E+01 0.21407823E-02 0.71381620E-03 0.71346924E-03 0.71349689E-03 0.14950000E+01 0.21399929E-02 0.71355297E-03 0.71320614E-03 0.71323379E-03 0.14952000E+01 0.21392040E-02 0.71328992E-03 0.71294323E-03 0.71297087E-03 0.14954000E+01 0.21384156E-02 0.71302705E-03 0.71268048E-03 0.71270811E-03 0.14956000E+01 0.21376278E-02 0.71276435E-03 0.71241791E-03 0.71244554E-03 0.14958000E+01 0.21368405E-02 0.71250182E-03 0.71215552E-03 0.71218314E-03 0.14960000E+01 0.21360537E-02 0.71223947E-03 0.71189330E-03 0.71192091E-03 0.14962000E+01 0.21352674E-02 0.71197730E-03 0.71163125E-03 0.71165886E-03 0.14964000E+01 0.21344817E-02 0.71171530E-03 0.71136938E-03 0.71139698E-03 0.14966000E+01 0.21336964E-02 0.71145347E-03 0.71110768E-03 0.71113528E-03 0.14968000E+01 0.21329117E-02 0.71119182E-03 0.71084616E-03 0.71087375E-03 0.14970000E+01 0.21321275E-02 0.71093034E-03 0.71058481E-03 0.71061239E-03 0.14972000E+01 0.21313439E-02 0.71066904E-03 0.71032364E-03 0.71035121E-03 0.14974000E+01 0.21305607E-02 0.71040790E-03 0.71006264E-03 0.71009020E-03 0.14976000E+01 0.21297781E-02 0.71014695E-03 0.70980181E-03 0.70982936E-03 0.14978000E+01 0.21289960E-02 0.70988616E-03 0.70954115E-03 0.70956870E-03 0.14980000E+01 0.21282144E-02 0.70962555E-03 0.70928067E-03 0.70930821E-03 0.14982000E+01 0.21274334E-02 0.70936511E-03 0.70902036E-03 0.70904790E-03 0.14984000E+01 0.21266528E-02 0.70910485E-03 0.70876023E-03 0.70878775E-03 0.14986000E+01 0.21258728E-02 0.70884476E-03 0.70850026E-03 0.70852778E-03 0.14988000E+01 0.21250933E-02 0.70858484E-03 0.70824047E-03 0.70826798E-03 0.14990000E+01 0.21243143E-02 0.70832509E-03 0.70798085E-03 0.70800836E-03 0.14992000E+01 0.21235358E-02 0.70806551E-03 0.70772140E-03 0.70774890E-03 0.14994000E+01 0.21227579E-02 0.70780611E-03 0.70746213E-03 0.70748962E-03 0.14996000E+01 0.21219804E-02 0.70754688E-03 0.70720303E-03 0.70723051E-03 0.14998000E+01 0.21212035E-02 0.70728782E-03 0.70694409E-03 0.70697157E-03 TDDFPT/Examples/Makefile0000644000175000017500000000250412341371500013336 0ustar mbamba# Makefile for TDDFPT Examples #Modified for v4.0 by obm default: small_test normal_test: for dir in \ CH4 SiH4 CH4-PR Benzene CH4-BOND\ ; do \ if test -d $$dir ; then \ ( cd $$dir ; \ if test "$(MAKE)" = "" ; then make $(MFLAGS) TLDEPS= all ; \ else $(MAKE) $(MFLAGS) TLDEPS= all ; fi ) \ fi \ done small_test: @for dir in \ CH4 SiH4 Benzene\ ; do \ if test -d $$dir ; then \ ( cd $$dir ; \ if test "$(MAKE)" = "" ; then make $(MFLAGS) TLDEPS= small_test ; \ else $(MAKE) $(MFLAGS) TLDEPS= small_test ; fi ) \ fi \ done exx: for dir in \ CH4-TDHF CH4-PBE0 CH4-ECUTFOCK\ ; do \ if test -d $$dir ; then \ ( cd $$dir ; \ if test "$(MAKE)" = "" ; then make $(MFLAGS) TLDEPS= all ; \ else $(MAKE) $(MFLAGS) TLDEPS= all ; fi ) \ fi \ done small_exx: @for dir in \ CH4-TDHF CH4-PBE0 CH4-ECUTFOCK\ ; do \ if test -d $$dir ; then \ ( cd $$dir ; \ if test "$(MAKE)" = "" ; then make $(MFLAGS) TLDEPS= small_test ; \ else $(MAKE) $(MFLAGS) TLDEPS= small_test ; fi ) \ fi \ done clean : @for dir in \ CH4 SiH4 CH4-PR Benzene CH4-TDHF CH4-PBE0 CH4-ECUTFOCK\ ; do \ if test -d $$dir ; then \ ( cd $$dir ; \ if test "$(MAKE)" = "" ; then make $(MFLAGS) TLDEPS= clean ; \ else $(MAKE) $(MFLAGS) TLDEPS= clean ; fi ) \ fi \ done distclean: clean TDDFPT/Examples/CH4-ECUTFOCK/0000755000175000017500000000000012341371517013464 5ustar mbambaTDDFPT/Examples/CH4-ECUTFOCK/CH4.tddfpt-in0000644000175000017500000000021212341371476015654 0ustar mbamba&lr_input prefix="ch4", outdir='./out', restart_step=250, / &lr_control itermax=500, ipol=4 ecutfock=25d0 / TDDFPT/Examples/CH4-ECUTFOCK/CH4.tddfpt-st-in0000644000175000017500000000021012341371476016276 0ustar mbamba&lr_input prefix="ch4", outdir='./out', restart_step=250, / &lr_control itermax=5, ipol=1 ecutfock=25d0 / TDDFPT/Examples/CH4-ECUTFOCK/CH4.pw-in0000644000175000017500000000126712341371476015030 0ustar mbamba&control calculation = 'scf' title = 'TDDFPT CH4 Test (TDHF)' restart_mode='from_scratch', pseudo_dir = '../pseudo', outdir='./out', prefix='ch4' etot_conv_thr=1d-6 / &system ibrav = 1, celldm(1) = 15, nat = 5, ntyp = 2, ecutwfc = 25, input_dft = 'hf', nosym=.true. / &electrons / &ions / ATOMIC_SPECIES C 1.0 C.pz-vbc.UPF H 1.0 H.pz-vbc.UPF ATOMIC_POSITIONS {Angstrom} C 0.000000000 0.000000000 0.000000000 H 0.642814093 0.642814093 0.642814093 H -0.642814093 -0.642814093 0.642814093 H 0.642814093 -0.642814093 -0.642814093 H -0.642814093 0.642814093 -0.642814093 K_POINTS {gamma} TDDFPT/Examples/CH4-ECUTFOCK/CH4.pw-ref0000644000175000017500000005320612341371476015176 0ustar mbamba Program PWSCF v.4.3.2 starts on 14Dec2011 at 16:52:54 This program is part of the open-source Quantum ESPRESSO suite for quantum simulation of materials; please cite "P. Giannozzi et al., J. Phys.:Condens. Matter 21 395502 (2009); URL http://www.quantum-espresso.org", in publications or presentations arising from this work. More details at http://www.quantum-espresso.org/quote.php Parallel version (MPI), running on 4 processors R & G space division: proc/pool = 4 EXPERIMENTAL VERSION WITH EXACT EXCHANGE Current dimensions of program PWSCF are: Max number of different atomic species (ntypx) = 10 Max number of k-points (npk) = 40000 Max angular momentum in pseudopotentials (lmaxx) = 3 Reading input from CH4.pw-in Warning: card &IONS ignored Warning: card / ignored IMPORTANT: XC functional enforced from input : Exchange-correlation = HF ( 5 0 0 0 0) EXX-fraction = 1.00 Any further DFT definition will be discarded Please, verify this is what you really want file H.pz-vbc.UPF: wavefunction(s) 1S renormalized gamma-point specific algorithms are used Subspace diagonalization in iterative solution of the eigenvalue problem: a serial algorithm will be used Parallelization info -------------------- sticks: dense smooth PW G-vecs: dense smooth PW Min 445 445 108 14262 14262 1776 Max 452 452 110 14264 14264 1783 Sum 1789 1789 437 57051 57051 7123 Tot 895 895 219 Title: TDDFPT CH4 Test (TDHF) bravais-lattice index = 1 lattice parameter (alat) = 15.0000 a.u. unit-cell volume = 3375.0000 (a.u.)^3 number of atoms/cell = 5 number of atomic types = 2 number of electrons = 8.00 number of Kohn-Sham states= 4 kinetic-energy cutoff = 25.0000 Ry charge density cutoff = 100.0000 Ry convergence threshold = 1.0E-06 mixing beta = 0.7000 number of iterations used = 8 plain mixing Exchange-correlation = HF ( 5 0 0 0 0) EXX-fraction = 1.00 celldm(1)= 15.000000 celldm(2)= 0.000000 celldm(3)= 0.000000 celldm(4)= 0.000000 celldm(5)= 0.000000 celldm(6)= 0.000000 crystal axes: (cart. coord. in units of alat) a(1) = ( 1.000000 0.000000 0.000000 ) a(2) = ( 0.000000 1.000000 0.000000 ) a(3) = ( 0.000000 0.000000 1.000000 ) reciprocal axes: (cart. coord. in units 2 pi/alat) b(1) = ( 1.000000 0.000000 0.000000 ) b(2) = ( 0.000000 1.000000 0.000000 ) b(3) = ( 0.000000 0.000000 1.000000 ) PseudoPot. # 1 for C read from file: ../pseudo/C.pz-vbc.UPF MD5 check sum: ab53dd623bfeb79c5a7b057bc96eae20 Pseudo is Norm-conserving, Zval = 4.0 Generated by new atomic code, or converted to UPF format Using radial grid of 269 points, 1 beta functions with: l(1) = 0 PseudoPot. # 2 for H read from file: ../pseudo/H.pz-vbc.UPF MD5 check sum: 90becb985b714f09656c73597998d266 Pseudo is Norm-conserving, Zval = 1.0 Generated by new atomic code, or converted to UPF format Using radial grid of 131 points, 0 beta functions with: atomic species valence mass pseudopotential C 4.00 1.00000 C ( 1.00) H 1.00 1.00000 H ( 1.00) No symmetry found Cartesian axes site n. atom positions (alat units) 1 C tau( 1) = ( 0.0000000 0.0000000 0.0000000 ) 2 H tau( 2) = ( 0.0809828 0.0809828 0.0809828 ) 3 H tau( 3) = ( -0.0809828 -0.0809828 0.0809828 ) 4 H tau( 4) = ( 0.0809828 -0.0809828 -0.0809828 ) 5 H tau( 5) = ( -0.0809828 0.0809828 -0.0809828 ) number of k points= 1 cart. coord. in units 2pi/alat k( 1) = ( 0.0000000 0.0000000 0.0000000), wk = 2.0000000 Dense grid: 28526 G-vectors FFT dimensions: ( 48, 48, 48) Largest allocated arrays est. size (Mb) dimensions Kohn-Sham Wavefunctions 0.05 Mb ( 888, 4) NL pseudopotentials 0.01 Mb ( 888, 1) Each V/rho on FFT grid 0.42 Mb ( 27648) Each G-vector array 0.05 Mb ( 7132) G-vector shells 0.00 Mb ( 461) Largest temporary arrays est. size (Mb) dimensions Auxiliary wavefunctions 0.11 Mb ( 888, 16) Each subspace H/S matrix 0.00 Mb ( 16, 16) Each matrix 0.00 Mb ( 1, 4) Arrays for rho mixing 3.38 Mb ( 27648, 8) Initial potential from superposition of free atoms Check: negative starting charge= -0.007168 starting charge 7.99987, renormalised to 8.00000 negative rho (up, down): 0.717E-02 0.000E+00 Starting wfc are 8 atomic wfcs total cpu time spent up to now is 0.1 secs per-process dynamical memory: 10.3 Mb Self-consistent Calculation iteration # 1 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 1.00E-02, avg # of iterations = 2.0 negative rho (up, down): 0.200E-02 0.000E+00 total cpu time spent up to now is 0.2 secs total energy = -14.80814773 Ry Harris-Foulkes estimate = -15.15961066 Ry estimated scf accuracy < 0.50888480 Ry iteration # 2 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 6.36E-03, avg # of iterations = 2.0 negative rho (up, down): 0.906E-03 0.000E+00 total cpu time spent up to now is 0.3 secs total energy = -14.92076762 Ry Harris-Foulkes estimate = -15.02287026 Ry estimated scf accuracy < 0.18489615 Ry iteration # 3 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 2.31E-03, avg # of iterations = 2.0 negative rho (up, down): 0.713E-06 0.000E+00 total cpu time spent up to now is 0.4 secs total energy = -14.96016761 Ry Harris-Foulkes estimate = -14.96260917 Ry estimated scf accuracy < 0.00450446 Ry iteration # 4 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 5.63E-05, avg # of iterations = 2.0 negative rho (up, down): 0.161E-04 0.000E+00 total cpu time spent up to now is 0.5 secs total energy = -14.96124904 Ry Harris-Foulkes estimate = -14.96142339 Ry estimated scf accuracy < 0.00035479 Ry iteration # 5 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 4.43E-06, avg # of iterations = 1.0 negative rho (up, down): 0.122E-06 0.000E+00 total cpu time spent up to now is 0.7 secs total energy = -14.96127571 Ry Harris-Foulkes estimate = -14.96127812 Ry estimated scf accuracy < 0.00000697 Ry iteration # 6 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 8.71E-08, avg # of iterations = 3.0 total cpu time spent up to now is 0.9 secs total energy = -14.96127846 Ry Harris-Foulkes estimate = -14.96128012 Ry estimated scf accuracy < 0.00000420 Ry iteration # 7 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 5.24E-08, avg # of iterations = 1.0 total cpu time spent up to now is 1.0 secs End of self-consistent calculation k = 0.0000 0.0000 0.0000 ( 3562 PWs) bands (ev): -15.3211 -7.7372 -7.7372 -7.7372 EXX: now go back to refine exchange calculation -11.4181117787429 Self-consistent Calculation iteration # 1 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 5.24E-08, avg # of iterations = 5.0 total cpu time spent up to now is 2.1 secs total energy = -15.47214725 Ry Harris-Foulkes estimate = -15.47440932 Ry estimated scf accuracy < 0.00248579 Ry iteration # 2 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 3.11E-05, avg # of iterations = 2.0 total cpu time spent up to now is 2.6 secs total energy = -15.47244308 Ry Harris-Foulkes estimate = -15.47249371 Ry estimated scf accuracy < 0.00005354 Ry iteration # 3 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 6.69E-07, avg # of iterations = 2.0 total cpu time spent up to now is 3.2 secs total energy = -15.47245663 Ry Harris-Foulkes estimate = -15.47246288 Ry estimated scf accuracy < 0.00000864 Ry iteration # 4 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 1.08E-07, avg # of iterations = 2.0 total cpu time spent up to now is 3.7 secs End of self-consistent calculation k = 0.0000 0.0000 0.0000 ( 3562 PWs) bands (ev): -25.2261 -14.1883 -14.1883 -14.1883 -11.4181117787429 -11.4850559178145 -11.5601429997824 est. exchange err (dexx) = 0.00407147 Ry ! total energy = -15.47652996 Ry Harris-Foulkes estimate = -15.47653005 Ry estimated scf accuracy < 0.00000009 Ry The total energy is the sum of the following terms: one-electron contribution = -45.93517830 Ry hartree contribution = 17.98537359 Ry xc contribution = 0.00000000 Ry ewald contribution = 6.76829034 Ry - averaged Fock potential = 11.48505592 Ry + Fock energy = -5.78007150 Ry NOW GO BACK TO REFINE HYBRID CALCULATION Self-consistent Calculation iteration # 1 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 1.08E-07, avg # of iterations = 4.0 total cpu time spent up to now is 4.6 secs total energy = -15.47805970 Ry Harris-Foulkes estimate = -15.47844094 Ry estimated scf accuracy < 0.00041895 Ry iteration # 2 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 5.24E-06, avg # of iterations = 2.0 total cpu time spent up to now is 5.1 secs total energy = -15.47811287 Ry Harris-Foulkes estimate = -15.47811737 Ry estimated scf accuracy < 0.00000473 Ry iteration # 3 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 5.91E-08, avg # of iterations = 2.0 total cpu time spent up to now is 5.7 secs End of self-consistent calculation k = 0.0000 0.0000 0.0000 ( 3562 PWs) bands (ev): -25.2063 -14.2282 -14.2282 -14.2282 -11.5601429997824 -11.5869896356417 -11.6151434444530 est. exchange err (dexx) = 0.00065359 Ry ! total energy = -15.47876746 Ry Harris-Foulkes estimate = -15.47876758 Ry estimated scf accuracy < 0.00000012 Ry The total energy is the sum of the following terms: one-electron contribution = -46.07506845 Ry hartree contribution = 18.04859274 Ry xc contribution = 0.00000000 Ry ewald contribution = 6.76829034 Ry - averaged Fock potential = 11.58698964 Ry + Fock energy = -5.80757172 Ry NOW GO BACK TO REFINE HYBRID CALCULATION Self-consistent Calculation iteration # 1 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 5.91E-08, avg # of iterations = 4.0 total cpu time spent up to now is 7.6 secs total energy = -15.47903574 Ry Harris-Foulkes estimate = -15.47911261 Ry estimated scf accuracy < 0.00008447 Ry iteration # 2 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 1.06E-06, avg # of iterations = 2.0 total cpu time spent up to now is 8.2 secs total energy = -15.47904808 Ry Harris-Foulkes estimate = -15.47904963 Ry estimated scf accuracy < 0.00000168 Ry iteration # 3 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 2.09E-08, avg # of iterations = 2.0 total cpu time spent up to now is 8.7 secs End of self-consistent calculation k = 0.0000 0.0000 0.0000 ( 3562 PWs) bands (ev): -25.1943 -14.2445 -14.2445 -14.2445 -11.6151434444530 -11.6256365710141 -11.6363781349041 est. exchange err (dexx) = 0.00012422 Ry ! total energy = -15.47917265 Ry Harris-Foulkes estimate = -15.47917279 Ry estimated scf accuracy < 0.00000014 Ry The total energy is the sum of the following terms: one-electron contribution = -46.12291951 Ry hartree contribution = 18.06800902 Ry xc contribution = 0.00000000 Ry ewald contribution = 6.76829034 Ry - averaged Fock potential = 11.62563657 Ry + Fock energy = -5.81818907 Ry NOW GO BACK TO REFINE HYBRID CALCULATION Self-consistent Calculation iteration # 1 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 2.09E-08, avg # of iterations = 4.0 total cpu time spent up to now is 9.6 secs total energy = -15.47922451 Ry Harris-Foulkes estimate = -15.47924048 Ry estimated scf accuracy < 0.00001755 Ry iteration # 2 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 2.19E-07, avg # of iterations = 2.0 total cpu time spent up to now is 10.2 secs End of self-consistent calculation k = 0.0000 0.0000 0.0000 ( 3562 PWs) bands (ev): -25.1994 -14.2609 -14.2609 -14.2609 -11.6363781349041 -11.6411785936653 -11.6460292122734 est. exchange err (dexx) = 0.00002508 Ry ! total energy = -15.47925233 Ry Harris-Foulkes estimate = -15.47925284 Ry estimated scf accuracy < 0.00000051 Ry The total energy is the sum of the following terms: one-electron contribution = -46.14287532 Ry hartree contribution = 18.07716867 Ry xc contribution = 0.00000000 Ry ewald contribution = 6.76829034 Ry - averaged Fock potential = 11.64117859 Ry + Fock energy = -5.82301461 Ry NOW GO BACK TO REFINE HYBRID CALCULATION Self-consistent Calculation iteration # 1 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 2.19E-07, avg # of iterations = 2.0 total cpu time spent up to now is 10.9 secs total energy = -15.47926240 Ry Harris-Foulkes estimate = -15.47926641 Ry estimated scf accuracy < 0.00000441 Ry iteration # 2 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 5.51E-08, avg # of iterations = 2.0 total cpu time spent up to now is 11.4 secs End of self-consistent calculation k = 0.0000 0.0000 0.0000 ( 3562 PWs) bands (ev): -25.1966 -14.2635 -14.2635 -14.2635 -11.6460292122734 -11.6478401445780 -11.6496610327406 est. exchange err (dexx) = 0.00000498 Ry ! total energy = -15.47926824 Ry Harris-Foulkes estimate = -15.47926845 Ry estimated scf accuracy < 0.00000021 Ry The total energy is the sum of the following terms: one-electron contribution = -46.15007957 Ry hartree contribution = 18.07951137 Ry xc contribution = 0.00000000 Ry ewald contribution = 6.76829034 Ry - averaged Fock potential = 11.64784014 Ry + Fock energy = -5.82483052 Ry NOW GO BACK TO REFINE HYBRID CALCULATION Self-consistent Calculation iteration # 1 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 5.51E-08, avg # of iterations = 2.0 total cpu time spent up to now is 12.1 secs total energy = -15.47927028 Ry Harris-Foulkes estimate = -15.47927152 Ry estimated scf accuracy < 0.00000137 Ry iteration # 2 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 1.71E-08, avg # of iterations = 2.0 total cpu time spent up to now is 12.6 secs End of self-consistent calculation k = 0.0000 0.0000 0.0000 ( 3562 PWs) bands (ev): -25.1958 -14.2650 -14.2650 -14.2650 -11.6496610327406 -11.6503659355321 -11.6510729053309 est. exchange err (dexx) = 0.00000103 Ry ! total energy = -15.47927164 Ry Harris-Foulkes estimate = -15.47927177 Ry estimated scf accuracy < 0.00000012 Ry The total energy is the sum of the following terms: one-electron contribution = -46.15236648 Ry hartree contribution = 18.07997501 Ry xc contribution = 0.00000000 Ry ewald contribution = 6.76829034 Ry - averaged Fock potential = 11.65036594 Ry + Fock energy = -5.82553645 Ry NOW GO BACK TO REFINE HYBRID CALCULATION Self-consistent Calculation iteration # 1 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 1.71E-08, avg # of iterations = 2.0 total cpu time spent up to now is 14.3 secs End of self-consistent calculation k = 0.0000 0.0000 0.0000 ( 3562 PWs) bands (ev): -25.1916 -14.2633 -14.2633 -14.2633 -11.6510729053309 -11.6510663790173 -11.6510610467346 est. exchange err (dexx) = 0.00000060 Ry ! total energy = -15.47927262 Ry Harris-Foulkes estimate = -15.47927313 Ry estimated scf accuracy < 0.00000051 Ry The total energy is the sum of the following terms: one-electron contribution = -46.15081621 Ry hartree contribution = 18.07771740 Ry xc contribution = 0.00000000 Ry ewald contribution = 6.76829034 Ry - averaged Fock potential = 11.65106638 Ry + Fock energy = -5.82553052 Ry convergence has been achieved in 1 iterations Writing output data file ch4.save init_run : 0.06s CPU 0.11s WALL ( 1 calls) electrons : 7.25s CPU 14.25s WALL ( 1 calls) Called by init_run: wfcinit : 0.01s CPU 0.03s WALL ( 1 calls) potinit : 0.02s CPU 0.03s WALL ( 1 calls) Called by electrons: c_bands : 5.25s CPU 8.58s WALL ( 24 calls) sum_band : 0.25s CPU 0.58s WALL ( 24 calls) v_of_rho : 0.13s CPU 0.20s WALL ( 26 calls) mix_rho : 0.11s CPU 0.17s WALL ( 24 calls) Called by c_bands: init_us_2 : 0.01s CPU 0.01s WALL ( 49 calls) regterg : 5.24s CPU 8.57s WALL ( 24 calls) Called by *egterg: h_psi : 5.20s CPU 8.50s WALL ( 81 calls) g_psi : 0.01s CPU 0.01s WALL ( 56 calls) rdiaghg : 0.01s CPU 0.01s WALL ( 73 calls) Called by h_psi: add_vuspsi : 0.00s CPU 0.00s WALL ( 81 calls) General routines calbec : 0.01s CPU 0.04s WALL ( 81 calls) fft : 0.25s CPU 0.61s WALL ( 93 calls) ffts : 2.91s CPU 5.45s WALL ( 1136 calls) fftw : 1.64s CPU 3.73s WALL ( 960 calls) davcio : 0.00s CPU 0.00s WALL ( 24 calls) Parallel routines fft_scatter : 1.40s CPU 2.29s WALL ( 2189 calls) EXX routines exx_grid : 0.00s CPU 0.00s WALL ( 1 calls) exxinit : 0.16s CPU 0.36s WALL ( 8 calls) vexx : 4.57s CPU 7.52s WALL ( 60 calls) exxen2 : 1.09s CPU 3.86s WALL ( 25 calls) PWSCF : 7.38s CPU 14.47s WALL This run was terminated on: 16:53: 9 14Dec2011 =------------------------------------------------------------------------------= JOB DONE. =------------------------------------------------------------------------------= TDDFPT/Examples/CH4-ECUTFOCK/CH4.tddfpt-ref0000644000175000017500000250736212341371476016046 0ustar mbamba Program TDDFPT v.5.0.1 starts on 19Aug2012 at 20: 0:48 This program is part of the open-source Quantum ESPRESSO suite for quantum simulation of materials; please cite "P. Giannozzi et al., J. Phys.:Condens. Matter 21 395502 (2009); URL http://www.quantum-espresso.org", in publications or presentations arising from this work. More details at http://www.quantum-espresso.org/quote.php Parallel version (MPI), running on 4 processors R & G space division: proc/pool = 4 ---------------------------------------- This is TDDFPT (Time Dependent Density Functional Perturbation Theory) Sub Version: 0.9 ---------------------------------------- Ultrasoft (Vanderbilt) Pseudopotentials Info: using nr1, nr2, nr3 values from input Info: using nr1s, nr2s, nr3s values from input IMPORTANT: XC functional enforced from input : Exchange-correlation = HF ( 5 0 0 0 0) EXX-fraction = 1.00 Any further DFT definition will be discarded Please, verify this is what you really want file H.pz-vbc.UPF: wavefunction(s) 1S renormalized Parallelization info -------------------- sticks: dense smooth PW G-vecs: dense smooth PW Min 445 445 108 14262 14262 1776 Max 452 452 110 14264 14264 1783 Sum 1789 1789 437 57051 57051 7123 Tot 895 895 219 EXX fraction changed: 1.00 EXX Screening parameter changed: 0.0000000 Is it hybrid? T Is it hybrid? T Is it hybrid? T Subspace diagonalization in iterative solution of the eigenvalue problem: a serial algorithm will be used Lanczos linear response spectrum calculation Number of Lanczos iterations = 500 Gamma point algorithm Is it hybrid? T lr_wfcinit_spectrum: finished lr_solve_e Norm of initial Lanczos vectors= 0.939778229070727 Starting Lanczos loop 1 Lanczos iteration: 1 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal alpha(00000001)=0.000000000000000E+00 beta (00000002)=0.202673021811089E+01 gamma(00000002)=0.202673021811089E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 2 z1= 1 0.629150058624703E+00 0.000000000000000E+00 z1= 2 -.840273864204100E-08 0.000000000000000E+00 z1= 3 -.163965601648408E-07 0.000000000000000E+00 alpha(00000002)=0.000000000000000E+00 beta (00000003)=0.676214891224268E+01 gamma(00000003)=0.676214891224268E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 3 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000003)=0.000000000000000E+00 beta (00000004)=0.144232739820086E+02 gamma(00000004)=0.144232739820086E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 4 z1= 1 -.235142133460567E+00 0.000000000000000E+00 z1= 2 0.866217182834625E-08 0.000000000000000E+00 z1= 3 0.270095794742495E-09 0.000000000000000E+00 alpha(00000004)=0.000000000000000E+00 beta (00000005)=0.123530670086972E+02 gamma(00000005)=0.123530670086972E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 5 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000005)=0.000000000000000E+00 beta (00000006)=0.140729526537724E+02 gamma(00000006)=0.140729526537724E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 6 z1= 1 0.183518344796760E+00 0.000000000000000E+00 z1= 2 0.695447408861904E-09 0.000000000000000E+00 z1= 3 0.437363424536175E-07 0.000000000000000E+00 alpha(00000006)=0.000000000000000E+00 beta (00000007)=0.125639460939501E+02 gamma(00000007)=0.125639460939501E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 7 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000007)=0.000000000000000E+00 beta (00000008)=0.137603621069532E+02 gamma(00000008)=0.137603621069532E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 8 z1= 1 -.154635968680479E+00 0.000000000000000E+00 z1= 2 -.656810995695867E-08 0.000000000000000E+00 z1= 3 -.606233808449598E-07 0.000000000000000E+00 alpha(00000008)=0.000000000000000E+00 beta (00000009)=0.127447797510938E+02 gamma(00000009)=0.127447797510938E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 9 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000009)=0.000000000000000E+00 beta (00000010)=0.137234352882803E+02 gamma(00000010)=0.137234352882803E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 10 z1= 1 0.135281233150081E+00 0.000000000000000E+00 z1= 2 0.124907214545458E-07 0.000000000000000E+00 z1= 3 0.459385836294680E-07 0.000000000000000E+00 alpha(00000010)=0.000000000000000E+00 beta (00000011)=0.128469548674462E+02 gamma(00000011)=0.128469548674462E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 11 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000011)=0.000000000000000E+00 beta (00000012)=0.137259794397280E+02 gamma(00000012)=0.137259794397280E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 12 z1= 1 -.120560894800433E+00 0.000000000000000E+00 z1= 2 -.191357780471996E-07 0.000000000000000E+00 z1= 3 -.181100156138459E-07 0.000000000000000E+00 alpha(00000012)=0.000000000000000E+00 beta (00000013)=0.128257492973719E+02 gamma(00000013)=0.128257492973719E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 13 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000013)=0.000000000000000E+00 beta (00000014)=0.137037726883869E+02 gamma(00000014)=0.137037726883869E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 14 z1= 1 0.108228041803401E+00 0.000000000000000E+00 z1= 2 0.262307425728109E-07 0.000000000000000E+00 z1= 3 -.190503395568241E-07 0.000000000000000E+00 alpha(00000014)=0.000000000000000E+00 beta (00000015)=0.128910516611210E+02 gamma(00000015)=0.128910516611210E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 15 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000015)=0.000000000000000E+00 beta (00000016)=0.137488974722631E+02 gamma(00000016)=0.137488974722631E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 16 z1= 1 -.978708753595188E-01 0.000000000000000E+00 z1= 2 -.325463890751138E-07 0.000000000000000E+00 z1= 3 0.551577706954867E-07 0.000000000000000E+00 alpha(00000016)=0.000000000000000E+00 beta (00000017)=0.128678064299995E+02 gamma(00000017)=0.128678064299995E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 17 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000017)=0.000000000000000E+00 beta (00000018)=0.135655622177478E+02 gamma(00000018)=0.135655622177478E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 18 z1= 1 0.898837726280117E-01 0.000000000000000E+00 z1= 2 0.382501080817624E-07 0.000000000000000E+00 z1= 3 -.913049027866358E-07 0.000000000000000E+00 alpha(00000018)=0.000000000000000E+00 beta (00000019)=0.127873625177482E+02 gamma(00000019)=0.127873625177482E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 19 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000019)=0.000000000000000E+00 beta (00000020)=0.135613708018364E+02 gamma(00000020)=0.135613708018364E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 20 z1= 1 -.823804034335180E-01 0.000000000000000E+00 z1= 2 -.427589863178160E-07 0.000000000000000E+00 z1= 3 0.115703501863394E-06 0.000000000000000E+00 alpha(00000020)=0.000000000000000E+00 beta (00000021)=0.128376440130321E+02 gamma(00000021)=0.128376440130321E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 21 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000021)=0.000000000000000E+00 beta (00000022)=0.136499906752447E+02 gamma(00000022)=0.136499906752447E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 22 z1= 1 0.755596688406456E-01 0.000000000000000E+00 z1= 2 0.460254935396448E-07 0.000000000000000E+00 z1= 3 -.127185079059114E-06 0.000000000000000E+00 alpha(00000022)=0.000000000000000E+00 beta (00000023)=0.129827357115315E+02 gamma(00000023)=0.129827357115315E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 23 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000023)=0.000000000000000E+00 beta (00000024)=0.134495810816493E+02 gamma(00000024)=0.134495810816493E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 24 z1= 1 -.713477623563347E-01 0.000000000000000E+00 z1= 2 -.501904883539600E-07 0.000000000000000E+00 z1= 3 0.130693814827409E-06 0.000000000000000E+00 alpha(00000024)=0.000000000000000E+00 beta (00000025)=0.126681686475872E+02 gamma(00000025)=0.126681686475872E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 25 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000025)=0.000000000000000E+00 beta (00000026)=0.137615932260197E+02 gamma(00000026)=0.137615932260197E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 26 z1= 1 0.644237872368403E-01 0.000000000000000E+00 z1= 2 0.513204286376606E-07 0.000000000000000E+00 z1= 3 -.118433528163443E-06 0.000000000000000E+00 alpha(00000026)=0.000000000000000E+00 beta (00000027)=0.130623628728481E+02 gamma(00000027)=0.130623628728481E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 27 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000027)=0.000000000000000E+00 beta (00000028)=0.135141714258760E+02 gamma(00000028)=0.135141714258760E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 28 z1= 1 -.612013272530456E-01 0.000000000000000E+00 z1= 2 -.546432449045897E-07 0.000000000000000E+00 z1= 3 0.111024831828420E-06 0.000000000000000E+00 alpha(00000028)=0.000000000000000E+00 beta (00000029)=0.130061878213807E+02 gamma(00000029)=0.130061878213807E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 29 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000029)=0.000000000000000E+00 beta (00000030)=0.137121925412554E+02 gamma(00000030)=0.137121925412554E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 30 z1= 1 0.571692727778034E-01 0.000000000000000E+00 z1= 2 0.567659531377357E-07 0.000000000000000E+00 z1= 3 -.107161750378774E-06 0.000000000000000E+00 alpha(00000030)=0.000000000000000E+00 beta (00000031)=0.128582599468132E+02 gamma(00000031)=0.128582599468132E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 31 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000031)=0.000000000000000E+00 beta (00000032)=0.136045206015246E+02 gamma(00000032)=0.136045206015246E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 32 z1= 1 -.532957818833300E-01 0.000000000000000E+00 z1= 2 -.585669995521731E-07 0.000000000000000E+00 z1= 3 0.112949008583768E-06 0.000000000000000E+00 alpha(00000032)=0.000000000000000E+00 beta (00000033)=0.128128174889963E+02 gamma(00000033)=0.128128174889963E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 33 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000033)=0.000000000000000E+00 beta (00000034)=0.137299925394599E+02 gamma(00000034)=0.137299925394599E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 34 z1= 1 0.490959203287647E-01 0.000000000000000E+00 z1= 2 0.597085463311525E-07 0.000000000000000E+00 z1= 3 -.124582873394083E-06 0.000000000000000E+00 alpha(00000034)=0.000000000000000E+00 beta (00000035)=0.126998686637421E+02 gamma(00000035)=0.126998686637421E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 35 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000035)=0.000000000000000E+00 beta (00000036)=0.133734189351183E+02 gamma(00000036)=0.133734189351183E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 36 z1= 1 -.459821406604380E-01 0.000000000000000E+00 z1= 2 -.620258427379977E-07 0.000000000000000E+00 z1= 3 0.152293986271533E-06 0.000000000000000E+00 alpha(00000036)=0.000000000000000E+00 beta (00000037)=0.129695295143556E+02 gamma(00000037)=0.129695295143556E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 37 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000037)=0.000000000000000E+00 beta (00000038)=0.134594521737742E+02 gamma(00000038)=0.134594521737742E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 38 z1= 1 0.437563129991152E-01 0.000000000000000E+00 z1= 2 0.660801477286865E-07 0.000000000000000E+00 z1= 3 -.190605487244283E-06 0.000000000000000E+00 alpha(00000038)=0.000000000000000E+00 beta (00000039)=0.129374606566869E+02 gamma(00000039)=0.129374606566869E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 39 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000039)=0.000000000000000E+00 beta (00000040)=0.134403551882438E+02 gamma(00000040)=0.134403551882438E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 40 z1= 1 -.416197860842908E-01 0.000000000000000E+00 z1= 2 -.704285135575550E-07 0.000000000000000E+00 z1= 3 0.231269748355873E-06 0.000000000000000E+00 alpha(00000040)=0.000000000000000E+00 beta (00000041)=0.128080733216809E+02 gamma(00000041)=0.128080733216809E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 41 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000041)=0.000000000000000E+00 beta (00000042)=0.136926848913838E+02 gamma(00000042)=0.136926848913838E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 42 z1= 1 0.384618026776527E-01 0.000000000000000E+00 z1= 2 0.719597071860423E-07 0.000000000000000E+00 z1= 3 -.268467377170485E-06 0.000000000000000E+00 alpha(00000042)=0.000000000000000E+00 beta (00000043)=0.127889284661196E+02 gamma(00000043)=0.127889284661196E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 43 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000043)=0.000000000000000E+00 beta (00000044)=0.136041841374313E+02 gamma(00000044)=0.136041841374313E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 44 z1= 1 -.357055494798439E-01 0.000000000000000E+00 z1= 2 -.749579048241189E-07 0.000000000000000E+00 z1= 3 0.301970754040381E-06 0.000000000000000E+00 alpha(00000044)=0.000000000000000E+00 beta (00000045)=0.125338660566398E+02 gamma(00000045)=0.125338660566398E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 45 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000045)=0.000000000000000E+00 beta (00000046)=0.133781093437231E+02 gamma(00000046)=0.133781093437231E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 46 z1= 1 0.329952684561046E-01 0.000000000000000E+00 z1= 2 0.790621094808042E-07 0.000000000000000E+00 z1= 3 -.329865072948906E-06 0.000000000000000E+00 alpha(00000046)=0.000000000000000E+00 beta (00000047)=0.124794999257447E+02 gamma(00000047)=0.124794999257447E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 47 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000047)=0.000000000000000E+00 beta (00000048)=0.135947237803423E+02 gamma(00000048)=0.135947237803423E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 48 z1= 1 -.297955414839658E-01 0.000000000000000E+00 z1= 2 -.820529257846217E-07 0.000000000000000E+00 z1= 3 0.343782189837077E-06 0.000000000000000E+00 alpha(00000048)=0.000000000000000E+00 beta (00000049)=0.131024582109477E+02 gamma(00000049)=0.131024582109477E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 49 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000049)=0.000000000000000E+00 beta (00000050)=0.138619236519730E+02 gamma(00000050)=0.138619236519730E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 50 z1= 1 0.277672389109103E-01 0.000000000000000E+00 z1= 2 0.876694810246145E-07 0.000000000000000E+00 z1= 3 -.356147322856030E-06 0.000000000000000E+00 alpha(00000050)=0.000000000000000E+00 beta (00000051)=0.127745778290980E+02 gamma(00000051)=0.127745778290980E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 51 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000051)=0.000000000000000E+00 beta (00000052)=0.133888687279515E+02 gamma(00000052)=0.133888687279515E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 52 z1= 1 -.260939795951856E-01 0.000000000000000E+00 z1= 2 -.942457892552304E-07 0.000000000000000E+00 z1= 3 0.363398015388737E-06 0.000000000000000E+00 alpha(00000052)=0.000000000000000E+00 beta (00000053)=0.126291466491933E+02 gamma(00000053)=0.126291466491933E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 53 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000053)=0.000000000000000E+00 beta (00000054)=0.132483579616338E+02 gamma(00000054)=0.132483579616338E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 54 z1= 1 0.244847518056553E-01 0.000000000000000E+00 z1= 2 0.100962877129865E-06 0.000000000000000E+00 z1= 3 -.354927159912474E-06 0.000000000000000E+00 alpha(00000054)=0.000000000000000E+00 beta (00000055)=0.133544750155002E+02 gamma(00000055)=0.133544750155002E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 55 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000055)=0.000000000000000E+00 beta (00000056)=0.135533922797862E+02 gamma(00000056)=0.135533922797862E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 56 z1= 1 -.238032108994679E-01 0.000000000000000E+00 z1= 2 -.110368548547797E-06 0.000000000000000E+00 z1= 3 0.360526126443658E-06 0.000000000000000E+00 alpha(00000056)=0.000000000000000E+00 beta (00000057)=0.131799135053282E+02 gamma(00000057)=0.131799135053282E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 57 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000057)=0.000000000000000E+00 beta (00000058)=0.132398834018426E+02 gamma(00000058)=0.132398834018426E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 58 z1= 1 0.233925247225079E-01 0.000000000000000E+00 z1= 2 0.120922507826360E-06 0.000000000000000E+00 z1= 3 -.371818083547398E-06 0.000000000000000E+00 alpha(00000058)=0.000000000000000E+00 beta (00000059)=0.127465058059598E+02 gamma(00000059)=0.127465058059598E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 59 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000059)=0.000000000000000E+00 beta (00000060)=0.136005182784048E+02 gamma(00000060)=0.136005182784048E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 60 z1= 1 -.216461242959374E-01 0.000000000000000E+00 z1= 2 -.124772258895504E-06 0.000000000000000E+00 z1= 3 0.349336032889956E-06 0.000000000000000E+00 alpha(00000060)=0.000000000000000E+00 beta (00000061)=0.132678844235427E+02 gamma(00000061)=0.132678844235427E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 61 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000061)=0.000000000000000E+00 beta (00000062)=0.139178909953363E+02 gamma(00000062)=0.139178909953363E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 62 z1= 1 0.203695029076514E-01 0.000000000000000E+00 z1= 2 0.130875823545727E-06 0.000000000000000E+00 z1= 3 -.330036085911432E-06 0.000000000000000E+00 alpha(00000062)=0.000000000000000E+00 beta (00000063)=0.131207411596398E+02 gamma(00000063)=0.131207411596398E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 63 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000063)=0.000000000000000E+00 beta (00000064)=0.135797832303808E+02 gamma(00000064)=0.135797832303808E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 64 z1= 1 -.193892717470645E-01 0.000000000000000E+00 z1= 2 -.139592112507157E-06 0.000000000000000E+00 z1= 3 0.314591877344185E-06 0.000000000000000E+00 alpha(00000064)=0.000000000000000E+00 beta (00000065)=0.125572690848644E+02 gamma(00000065)=0.125572690848644E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 65 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000065)=0.000000000000000E+00 beta (00000066)=0.134171278979363E+02 gamma(00000066)=0.134171278979363E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 66 z1= 1 0.178765951660705E-01 0.000000000000000E+00 z1= 2 0.144666119569759E-06 0.000000000000000E+00 z1= 3 -.294704469438317E-06 0.000000000000000E+00 alpha(00000066)=0.000000000000000E+00 beta (00000067)=0.132069999084894E+02 gamma(00000067)=0.132069999084894E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 67 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000067)=0.000000000000000E+00 beta (00000068)=0.138669424743654E+02 gamma(00000068)=0.138669424743654E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 68 z1= 1 -.168651754642724E-01 0.000000000000000E+00 z1= 2 -.150599548309413E-06 0.000000000000000E+00 z1= 3 0.282189779206830E-06 0.000000000000000E+00 alpha(00000068)=0.000000000000000E+00 beta (00000069)=0.130391530637199E+02 gamma(00000069)=0.130391530637199E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 69 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000069)=0.000000000000000E+00 beta (00000070)=0.133420143378031E+02 gamma(00000070)=0.133420143378031E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 70 z1= 1 0.163359088127265E-01 0.000000000000000E+00 z1= 2 0.161336225225003E-06 0.000000000000000E+00 z1= 3 -.277704102007924E-06 0.000000000000000E+00 alpha(00000070)=0.000000000000000E+00 beta (00000071)=0.127754741290283E+02 gamma(00000071)=0.127754741290283E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 71 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000071)=0.000000000000000E+00 beta (00000072)=0.139992873152062E+02 gamma(00000072)=0.139992873152062E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 72 z1= 1 -.148089933349067E-01 0.000000000000000E+00 z1= 2 -.161941928256137E-06 0.000000000000000E+00 z1= 3 0.258202167115835E-06 0.000000000000000E+00 alpha(00000072)=0.000000000000000E+00 beta (00000073)=0.128546511478302E+02 gamma(00000073)=0.128546511478302E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 73 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000073)=0.000000000000000E+00 beta (00000074)=0.132957949561374E+02 gamma(00000074)=0.132957949561374E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 74 z1= 1 0.142243332390544E-01 0.000000000000000E+00 z1= 2 0.173134682752811E-06 0.000000000000000E+00 z1= 3 -.247654981232086E-06 0.000000000000000E+00 alpha(00000074)=0.000000000000000E+00 beta (00000075)=0.122777267490482E+02 gamma(00000075)=0.122777267490482E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 75 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000075)=0.000000000000000E+00 beta (00000076)=0.134301661004207E+02 gamma(00000076)=0.134301661004207E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 76 z1= 1 -.129315626049474E-01 0.000000000000000E+00 z1= 2 -.175036934632264E-06 0.000000000000000E+00 z1= 3 0.228627881428340E-06 0.000000000000000E+00 alpha(00000076)=0.000000000000000E+00 beta (00000077)=0.128560655616164E+02 gamma(00000077)=0.128560655616164E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 77 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000077)=0.000000000000000E+00 beta (00000078)=0.139567552213125E+02 gamma(00000078)=0.139567552213125E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 78 z1= 1 0.119216730993951E-01 0.000000000000000E+00 z1= 2 0.178580657277886E-06 0.000000000000000E+00 z1= 3 -.219229435297996E-06 0.000000000000000E+00 alpha(00000078)=0.000000000000000E+00 beta (00000079)=0.127756125665761E+02 gamma(00000079)=0.127756125665761E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 79 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000079)=0.000000000000000E+00 beta (00000080)=0.134013279658667E+02 gamma(00000080)=0.134013279658667E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 80 z1= 1 -.114307975703188E-01 0.000000000000000E+00 z1= 2 -.190346159311024E-06 0.000000000000000E+00 z1= 3 0.212424874250451E-06 0.000000000000000E+00 alpha(00000080)=0.000000000000000E+00 beta (00000081)=0.126747061946801E+02 gamma(00000081)=0.126747061946801E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 81 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000081)=0.000000000000000E+00 beta (00000082)=0.140252584611283E+02 gamma(00000082)=0.140252584611283E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 82 z1= 1 0.104015700383554E-01 0.000000000000000E+00 z1= 2 0.191520617783339E-06 0.000000000000000E+00 z1= 3 -.194591632798760E-06 0.000000000000000E+00 alpha(00000082)=0.000000000000000E+00 beta (00000083)=0.128491969037544E+02 gamma(00000083)=0.128491969037544E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 83 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000083)=0.000000000000000E+00 beta (00000084)=0.131673867957805E+02 gamma(00000084)=0.131673867957805E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 84 z1= 1 -.102532488890623E-01 0.000000000000000E+00 z1= 2 -.208055690275981E-06 0.000000000000000E+00 z1= 3 0.188172603941806E-06 0.000000000000000E+00 alpha(00000084)=0.000000000000000E+00 beta (00000085)=0.128600923795502E+02 gamma(00000085)=0.128600923795502E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 85 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000085)=0.000000000000000E+00 beta (00000086)=0.142145561370626E+02 gamma(00000086)=0.142145561370626E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 86 z1= 1 0.923025451608858E-02 0.000000000000000E+00 z1= 2 0.207370242913483E-06 0.000000000000000E+00 z1= 3 -.176191597085155E-06 0.000000000000000E+00 alpha(00000086)=0.000000000000000E+00 beta (00000087)=0.126364293967111E+02 gamma(00000087)=0.126364293967111E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 87 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000087)=0.000000000000000E+00 beta (00000088)=0.133498553805562E+02 gamma(00000088)=0.133498553805562E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 88 z1= 1 -.856241836843385E-02 0.000000000000000E+00 z1= 2 -.217968898500983E-06 0.000000000000000E+00 z1= 3 0.191139621099918E-06 0.000000000000000E+00 alpha(00000088)=0.000000000000000E+00 beta (00000089)=0.129282576530699E+02 gamma(00000089)=0.129282576530699E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 89 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000089)=0.000000000000000E+00 beta (00000090)=0.137915256594274E+02 gamma(00000090)=0.137915256594274E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 90 z1= 1 0.780723516614442E-02 0.000000000000000E+00 z1= 2 0.225567484135386E-06 0.000000000000000E+00 z1= 3 -.195891805882214E-06 0.000000000000000E+00 alpha(00000090)=0.000000000000000E+00 beta (00000091)=0.125622367659029E+02 gamma(00000091)=0.125622367659029E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 91 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000091)=0.000000000000000E+00 beta (00000092)=0.129073400982629E+02 gamma(00000092)=0.129073400982629E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 92 z1= 1 -.736945677893487E-02 0.000000000000000E+00 z1= 2 -.244456698630675E-06 0.000000000000000E+00 z1= 3 0.204321784145296E-06 0.000000000000000E+00 alpha(00000092)=0.000000000000000E+00 beta (00000093)=0.134136081358105E+02 gamma(00000093)=0.134136081358105E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 93 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000093)=0.000000000000000E+00 beta (00000094)=0.132877214422733E+02 gamma(00000094)=0.132877214422733E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 94 z1= 1 0.726618238141558E-02 0.000000000000000E+00 z1= 2 0.268805138598470E-06 0.000000000000000E+00 z1= 3 -.220637178209061E-06 0.000000000000000E+00 alpha(00000094)=0.000000000000000E+00 beta (00000095)=0.124147917275235E+02 gamma(00000095)=0.124147917275235E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 95 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000095)=0.000000000000000E+00 beta (00000096)=0.130372569357860E+02 gamma(00000096)=0.130372569357860E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 96 z1= 1 -.676484949113816E-02 0.000000000000000E+00 z1= 2 -.278689672999956E-06 0.000000000000000E+00 z1= 3 0.231655793120794E-06 0.000000000000000E+00 alpha(00000096)=0.000000000000000E+00 beta (00000097)=0.127828844912395E+02 gamma(00000097)=0.127828844912395E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 97 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000097)=0.000000000000000E+00 beta (00000098)=0.128636388750918E+02 gamma(00000098)=0.128636388750918E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 98 z1= 1 0.652985758628710E-02 0.000000000000000E+00 z1= 2 0.299594439206021E-06 0.000000000000000E+00 z1= 3 -.260495737066578E-06 0.000000000000000E+00 alpha(00000098)=0.000000000000000E+00 beta (00000099)=0.120951315308652E+02 gamma(00000099)=0.120951315308652E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 99 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000099)=0.000000000000000E+00 beta (00000100)=0.135705147650889E+02 gamma(00000100)=0.135705147650889E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 100 z1= 1 -.570300303305746E-02 0.000000000000000E+00 z1= 2 -.287053040207066E-06 0.000000000000000E+00 z1= 3 0.258175665604103E-06 0.000000000000000E+00 alpha(00000100)=0.000000000000000E+00 beta (00000101)=0.130003502439338E+02 gamma(00000101)=0.130003502439338E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 101 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000101)=0.000000000000000E+00 beta (00000102)=0.130515076501356E+02 gamma(00000102)=0.130515076501356E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 102 z1= 1 0.570635280405348E-02 0.000000000000000E+00 z1= 2 0.304461821932708E-06 0.000000000000000E+00 z1= 3 -.296003348834988E-06 0.000000000000000E+00 alpha(00000102)=0.000000000000000E+00 beta (00000103)=0.136735186788689E+02 gamma(00000103)=0.136735186788689E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 103 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000103)=0.000000000000000E+00 beta (00000104)=0.134250023669421E+02 gamma(00000104)=0.134250023669421E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 104 z1= 1 -.601802824608929E-02 0.000000000000000E+00 z1= 2 -.325013409334645E-06 0.000000000000000E+00 z1= 3 0.343086503236628E-06 0.000000000000000E+00 alpha(00000104)=0.000000000000000E+00 beta (00000105)=0.130029793025714E+02 gamma(00000105)=0.130029793025714E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 105 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000105)=0.000000000000000E+00 beta (00000106)=0.141250413900026E+02 gamma(00000106)=0.141250413900026E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 106 z1= 1 0.578940717587060E-02 0.000000000000000E+00 z1= 2 0.313437583055343E-06 0.000000000000000E+00 z1= 3 -.361512715165292E-06 0.000000000000000E+00 alpha(00000106)=0.000000000000000E+00 beta (00000107)=0.132679888969992E+02 gamma(00000107)=0.132679888969992E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 107 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000107)=0.000000000000000E+00 beta (00000108)=0.133905764530302E+02 gamma(00000108)=0.133905764530302E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 108 z1= 1 -.598200022278927E-02 0.000000000000000E+00 z1= 2 -.325997606367978E-06 0.000000000000000E+00 z1= 3 0.409171076817848E-06 0.000000000000000E+00 alpha(00000108)=0.000000000000000E+00 beta (00000109)=0.136743427820062E+02 gamma(00000109)=0.136743427820062E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 109 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000109)=0.000000000000000E+00 beta (00000110)=0.125334603585353E+02 gamma(00000110)=0.125334603585353E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 110 z1= 1 0.670164628253673E-02 0.000000000000000E+00 z1= 2 0.371310898930610E-06 0.000000000000000E+00 z1= 3 -.497143473183440E-06 0.000000000000000E+00 alpha(00000110)=0.000000000000000E+00 beta (00000111)=0.130342238658263E+02 gamma(00000111)=0.130342238658263E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 111 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000111)=0.000000000000000E+00 beta (00000112)=0.137473342971325E+02 gamma(00000112)=0.137473342971325E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 112 z1= 1 -.647042984883641E-02 0.000000000000000E+00 z1= 2 -.364012499077387E-06 0.000000000000000E+00 z1= 3 0.518482558605838E-06 0.000000000000000E+00 alpha(00000112)=0.000000000000000E+00 beta (00000113)=0.127037963874492E+02 gamma(00000113)=0.127037963874492E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 113 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000113)=0.000000000000000E+00 beta (00000114)=0.137811269404598E+02 gamma(00000114)=0.137811269404598E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 114 z1= 1 0.611782851124320E-02 0.000000000000000E+00 z1= 2 0.346291646564348E-06 0.000000000000000E+00 z1= 3 -.513547903807502E-06 0.000000000000000E+00 alpha(00000114)=0.000000000000000E+00 beta (00000115)=0.119877091325558E+02 gamma(00000115)=0.119877091325558E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 115 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000115)=0.000000000000000E+00 beta (00000116)=0.136754806813896E+02 gamma(00000116)=0.136754806813896E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 116 z1= 1 -.559987764347192E-02 0.000000000000000E+00 z1= 2 -.316122580297897E-06 0.000000000000000E+00 z1= 3 0.482280172273619E-06 0.000000000000000E+00 alpha(00000116)=0.000000000000000E+00 beta (00000117)=0.124468388643660E+02 gamma(00000117)=0.124468388643660E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 117 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000117)=0.000000000000000E+00 beta (00000118)=0.134802362635714E+02 gamma(00000118)=0.134802362635714E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 118 z1= 1 0.536283537425429E-02 0.000000000000000E+00 z1= 2 0.305918650213548E-06 0.000000000000000E+00 z1= 3 -.470427830600618E-06 0.000000000000000E+00 alpha(00000118)=0.000000000000000E+00 beta (00000119)=0.129047926972368E+02 gamma(00000119)=0.129047926972368E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 119 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000119)=0.000000000000000E+00 beta (00000120)=0.134429872854969E+02 gamma(00000120)=0.134429872854969E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 120 z1= 1 -.521282007596917E-02 0.000000000000000E+00 z1= 2 -.306932986379391E-06 0.000000000000000E+00 z1= 3 0.466638536585496E-06 0.000000000000000E+00 alpha(00000120)=0.000000000000000E+00 beta (00000121)=0.128150213013634E+02 gamma(00000121)=0.128150213013634E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 121 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000121)=0.000000000000000E+00 beta (00000122)=0.134033611161746E+02 gamma(00000122)=0.134033611161746E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 122 z1= 1 0.497734193417390E-02 0.000000000000000E+00 z1= 2 0.305963452944952E-06 0.000000000000000E+00 z1= 3 -.458455374714446E-06 0.000000000000000E+00 alpha(00000122)=0.000000000000000E+00 beta (00000123)=0.127879388745147E+02 gamma(00000123)=0.127879388745147E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 123 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000123)=0.000000000000000E+00 beta (00000124)=0.135159109872369E+02 gamma(00000124)=0.135159109872369E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 124 z1= 1 -.467125653584227E-02 0.000000000000000E+00 z1= 2 -.301480280573418E-06 0.000000000000000E+00 z1= 3 0.441328072156957E-06 0.000000000000000E+00 alpha(00000124)=0.000000000000000E+00 beta (00000125)=0.129566919452536E+02 gamma(00000125)=0.129566919452536E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 125 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000125)=0.000000000000000E+00 beta (00000126)=0.137778488273195E+02 gamma(00000126)=0.137778488273195E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 126 z1= 1 0.442556105552238E-02 0.000000000000000E+00 z1= 2 0.295314000624096E-06 0.000000000000000E+00 z1= 3 -.427645663691567E-06 0.000000000000000E+00 alpha(00000126)=0.000000000000000E+00 beta (00000127)=0.128495370406384E+02 gamma(00000127)=0.128495370406384E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 127 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000127)=0.000000000000000E+00 beta (00000128)=0.138112887523193E+02 gamma(00000128)=0.138112887523193E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 128 z1= 1 -.421852903860724E-02 0.000000000000000E+00 z1= 2 -.287089861970152E-06 0.000000000000000E+00 z1= 3 0.403925749704165E-06 0.000000000000000E+00 alpha(00000128)=0.000000000000000E+00 beta (00000129)=0.132562783308323E+02 gamma(00000129)=0.132562783308323E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 129 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000129)=0.000000000000000E+00 beta (00000130)=0.135026234416551E+02 gamma(00000130)=0.135026234416551E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 130 z1= 1 0.420671852161654E-02 0.000000000000000E+00 z1= 2 0.294404020741851E-06 0.000000000000000E+00 z1= 3 -.394228985955872E-06 0.000000000000000E+00 alpha(00000130)=0.000000000000000E+00 beta (00000131)=0.125003625119823E+02 gamma(00000131)=0.125003625119823E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 131 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000131)=0.000000000000000E+00 beta (00000132)=0.135182368390764E+02 gamma(00000132)=0.135182368390764E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 132 z1= 1 -.390073879465575E-02 0.000000000000000E+00 z1= 2 -.285982815907693E-06 0.000000000000000E+00 z1= 3 0.365565723052172E-06 0.000000000000000E+00 alpha(00000132)=0.000000000000000E+00 beta (00000133)=0.124859206534720E+02 gamma(00000133)=0.124859206534720E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 133 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000133)=0.000000000000000E+00 beta (00000134)=0.134673534057310E+02 gamma(00000134)=0.134673534057310E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 134 z1= 1 0.355805520586809E-02 0.000000000000000E+00 z1= 2 0.279011139829241E-06 0.000000000000000E+00 z1= 3 -.341305582173337E-06 0.000000000000000E+00 alpha(00000134)=0.000000000000000E+00 beta (00000135)=0.126728963845606E+02 gamma(00000135)=0.126728963845606E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 135 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000135)=0.000000000000000E+00 beta (00000136)=0.137296581551575E+02 gamma(00000136)=0.137296581551575E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 136 z1= 1 -.318709166457134E-02 0.000000000000000E+00 z1= 2 -.270833406799433E-06 0.000000000000000E+00 z1= 3 0.316675611525047E-06 0.000000000000000E+00 alpha(00000136)=0.000000000000000E+00 beta (00000137)=0.127646944481343E+02 gamma(00000137)=0.127646944481343E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 137 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000137)=0.000000000000000E+00 beta (00000138)=0.131132610670116E+02 gamma(00000138)=0.131132610670116E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 138 z1= 1 0.304725374251265E-02 0.000000000000000E+00 z1= 2 0.277844073572238E-06 0.000000000000000E+00 z1= 3 -.299070046033147E-06 0.000000000000000E+00 alpha(00000138)=0.000000000000000E+00 beta (00000139)=0.123813080978069E+02 gamma(00000139)=0.123813080978069E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 139 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000139)=0.000000000000000E+00 beta (00000140)=0.137849146771940E+02 gamma(00000140)=0.137849146771940E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 140 z1= 1 -.281294638334735E-02 0.000000000000000E+00 z1= 2 -.262582653005709E-06 0.000000000000000E+00 z1= 3 0.267653198168273E-06 0.000000000000000E+00 alpha(00000140)=0.000000000000000E+00 beta (00000141)=0.131108897603427E+02 gamma(00000141)=0.131108897603427E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 141 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000141)=0.000000000000000E+00 beta (00000142)=0.134910894514315E+02 gamma(00000142)=0.134910894514315E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 142 z1= 1 0.289754189341173E-02 0.000000000000000E+00 z1= 2 0.268275862731412E-06 0.000000000000000E+00 z1= 3 -.270700481382882E-06 0.000000000000000E+00 alpha(00000142)=0.000000000000000E+00 beta (00000143)=0.125627974442447E+02 gamma(00000143)=0.125627974442447E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 143 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000143)=0.000000000000000E+00 beta (00000144)=0.134860353584613E+02 gamma(00000144)=0.134860353584613E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 144 z1= 1 -.296572998569793E-02 0.000000000000000E+00 z1= 2 -.263234119443363E-06 0.000000000000000E+00 z1= 3 0.267297934461366E-06 0.000000000000000E+00 alpha(00000144)=0.000000000000000E+00 beta (00000145)=0.130284069612389E+02 gamma(00000145)=0.130284069612389E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 145 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000145)=0.000000000000000E+00 beta (00000146)=0.138278930132631E+02 gamma(00000146)=0.138278930132631E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 146 z1= 1 0.306724212631426E-02 0.000000000000000E+00 z1= 2 0.260985881866353E-06 0.000000000000000E+00 z1= 3 -.264889831245074E-06 0.000000000000000E+00 alpha(00000146)=0.000000000000000E+00 beta (00000147)=0.132057124112300E+02 gamma(00000147)=0.132057124112300E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 147 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000147)=0.000000000000000E+00 beta (00000148)=0.138745583623596E+02 gamma(00000148)=0.138745583623596E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 148 z1= 1 -.311359682889204E-02 0.000000000000000E+00 z1= 2 -.261930046705004E-06 0.000000000000000E+00 z1= 3 0.256967865182550E-06 0.000000000000000E+00 alpha(00000148)=0.000000000000000E+00 beta (00000149)=0.129264554638623E+02 gamma(00000149)=0.129264554638623E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 149 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000149)=0.000000000000000E+00 beta (00000150)=0.133833939454362E+02 gamma(00000150)=0.133833939454362E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 150 z1= 1 0.318891480779159E-02 0.000000000000000E+00 z1= 2 0.267452935882732E-06 0.000000000000000E+00 z1= 3 -.248523819005751E-06 0.000000000000000E+00 alpha(00000150)=0.000000000000000E+00 beta (00000151)=0.126485217052492E+02 gamma(00000151)=0.126485217052492E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 151 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000151)=0.000000000000000E+00 beta (00000152)=0.139238360772501E+02 gamma(00000152)=0.139238360772501E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 152 z1= 1 -.298283075750659E-02 0.000000000000000E+00 z1= 2 -.255856393793340E-06 0.000000000000000E+00 z1= 3 0.224585740450341E-06 0.000000000000000E+00 alpha(00000152)=0.000000000000000E+00 beta (00000153)=0.128200668732931E+02 gamma(00000153)=0.128200668732931E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 153 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000153)=0.000000000000000E+00 beta (00000154)=0.141815902815053E+02 gamma(00000154)=0.141815902815053E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 154 z1= 1 0.274360359815144E-02 0.000000000000000E+00 z1= 2 0.243535131399294E-06 0.000000000000000E+00 z1= 3 -.209904479116316E-06 0.000000000000000E+00 alpha(00000154)=0.000000000000000E+00 beta (00000155)=0.126169688816609E+02 gamma(00000155)=0.126169688816609E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 155 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000155)=0.000000000000000E+00 beta (00000156)=0.133080256236255E+02 gamma(00000156)=0.133080256236255E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 156 z1= 1 -.264070107845308E-02 0.000000000000000E+00 z1= 2 -.244033712717018E-06 0.000000000000000E+00 z1= 3 0.215051150975081E-06 0.000000000000000E+00 alpha(00000156)=0.000000000000000E+00 beta (00000157)=0.126397347367505E+02 gamma(00000157)=0.126397347367505E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 157 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000157)=0.000000000000000E+00 beta (00000158)=0.138195485008323E+02 gamma(00000158)=0.138195485008323E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 158 z1= 1 0.239269857655152E-02 0.000000000000000E+00 z1= 2 0.235827011813971E-06 0.000000000000000E+00 z1= 3 -.204405944649599E-06 0.000000000000000E+00 alpha(00000158)=0.000000000000000E+00 beta (00000159)=0.131172933458229E+02 gamma(00000159)=0.131172933458229E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 159 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000159)=0.000000000000000E+00 beta (00000160)=0.138220966623941E+02 gamma(00000160)=0.138220966623941E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 160 z1= 1 -.222861820182499E-02 0.000000000000000E+00 z1= 2 -.237323004881622E-06 0.000000000000000E+00 z1= 3 0.197047215323405E-06 0.000000000000000E+00 alpha(00000160)=0.000000000000000E+00 beta (00000161)=0.129639366203003E+02 gamma(00000161)=0.129639366203003E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 161 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000161)=0.000000000000000E+00 beta (00000162)=0.133309313441778E+02 gamma(00000162)=0.133309313441778E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 162 z1= 1 0.206318949480420E-02 0.000000000000000E+00 z1= 2 0.244526226126089E-06 0.000000000000000E+00 z1= 3 -.200535611653775E-06 0.000000000000000E+00 alpha(00000162)=0.000000000000000E+00 beta (00000163)=0.125189965438206E+02 gamma(00000163)=0.125189965438206E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 163 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000163)=0.000000000000000E+00 beta (00000164)=0.134918252686645E+02 gamma(00000164)=0.134918252686645E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 164 z1= 1 -.172229390881665E-02 0.000000000000000E+00 z1= 2 -.239159144594823E-06 0.000000000000000E+00 z1= 3 0.205556038064444E-06 0.000000000000000E+00 alpha(00000164)=0.000000000000000E+00 beta (00000165)=0.128802997529175E+02 gamma(00000165)=0.128802997529175E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 165 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000165)=0.000000000000000E+00 beta (00000166)=0.137804239265206E+02 gamma(00000166)=0.137804239265206E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 166 z1= 1 0.135763934075602E-02 0.000000000000000E+00 z1= 2 0.234437943697906E-06 0.000000000000000E+00 z1= 3 -.218644851048987E-06 0.000000000000000E+00 alpha(00000166)=0.000000000000000E+00 beta (00000167)=0.126265444476578E+02 gamma(00000167)=0.126265444476578E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 167 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000167)=0.000000000000000E+00 beta (00000168)=0.142374803333580E+02 gamma(00000168)=0.142374803333580E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 168 z1= 1 -.948296092513377E-03 0.000000000000000E+00 z1= 2 -.217969487835120E-06 0.000000000000000E+00 z1= 3 0.216779772289964E-06 0.000000000000000E+00 alpha(00000168)=0.000000000000000E+00 beta (00000169)=0.122837706468041E+02 gamma(00000169)=0.122837706468041E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 169 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000169)=0.000000000000000E+00 beta (00000170)=0.138940522378569E+02 gamma(00000170)=0.138940522378569E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 170 z1= 1 0.722138748972498E-03 0.000000000000000E+00 z1= 2 0.202984264332942E-06 0.000000000000000E+00 z1= 3 -.218407631981572E-06 0.000000000000000E+00 alpha(00000170)=0.000000000000000E+00 beta (00000171)=0.130693534300686E+02 gamma(00000171)=0.130693534300686E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 171 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000171)=0.000000000000000E+00 beta (00000172)=0.136271330370884E+02 gamma(00000172)=0.136271330370884E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 172 z1= 1 -.623502513475371E-03 0.000000000000000E+00 z1= 2 -.205111706807191E-06 0.000000000000000E+00 z1= 3 0.236443619750176E-06 0.000000000000000E+00 alpha(00000172)=0.000000000000000E+00 beta (00000173)=0.121811393372039E+02 gamma(00000173)=0.121811393372039E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 173 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000173)=0.000000000000000E+00 beta (00000174)=0.132891882091524E+02 gamma(00000174)=0.132891882091524E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 174 z1= 1 0.492975881314170E-03 0.000000000000000E+00 z1= 2 0.200624150553620E-06 0.000000000000000E+00 z1= 3 -.235354608224309E-06 0.000000000000000E+00 alpha(00000174)=0.000000000000000E+00 beta (00000175)=0.130058002739243E+02 gamma(00000175)=0.130058002739243E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 175 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000175)=0.000000000000000E+00 beta (00000176)=0.135814591178633E+02 gamma(00000176)=0.135814591178633E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 176 z1= 1 -.392382516145859E-03 0.000000000000000E+00 z1= 2 -.205014878712929E-06 0.000000000000000E+00 z1= 3 0.233116064069660E-06 0.000000000000000E+00 alpha(00000176)=0.000000000000000E+00 beta (00000177)=0.130879550655107E+02 gamma(00000177)=0.130879550655107E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 177 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000177)=0.000000000000000E+00 beta (00000178)=0.138044956442216E+02 gamma(00000178)=0.138044956442216E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 178 z1= 1 0.246714689582666E-03 0.000000000000000E+00 z1= 2 0.206341601925990E-06 0.000000000000000E+00 z1= 3 -.213641324978115E-06 0.000000000000000E+00 alpha(00000178)=0.000000000000000E+00 beta (00000179)=0.125845949101556E+02 gamma(00000179)=0.125845949101556E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 179 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000179)=0.000000000000000E+00 beta (00000180)=0.132832349848978E+02 gamma(00000180)=0.132832349848978E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 180 z1= 1 -.119730261215615E-03 0.000000000000000E+00 z1= 2 -.207440563040591E-06 0.000000000000000E+00 z1= 3 0.200775949348210E-06 0.000000000000000E+00 alpha(00000180)=0.000000000000000E+00 beta (00000181)=0.126678198196701E+02 gamma(00000181)=0.126678198196701E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 181 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000181)=0.000000000000000E+00 beta (00000182)=0.137049251612295E+02 gamma(00000182)=0.137049251612295E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 182 z1= 1 -.109886270253760E-04 0.000000000000000E+00 z1= 2 0.201460462300146E-06 0.000000000000000E+00 z1= 3 -.192502899763324E-06 0.000000000000000E+00 alpha(00000182)=0.000000000000000E+00 beta (00000183)=0.127935569269925E+02 gamma(00000183)=0.127935569269925E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 183 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000183)=0.000000000000000E+00 beta (00000184)=0.134631367282979E+02 gamma(00000184)=0.134631367282979E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 184 z1= 1 0.135225270150337E-03 0.000000000000000E+00 z1= 2 -.200902069520973E-06 0.000000000000000E+00 z1= 3 0.175575559920515E-06 0.000000000000000E+00 alpha(00000184)=0.000000000000000E+00 beta (00000185)=0.130776930714984E+02 gamma(00000185)=0.130776930714984E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 185 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000185)=0.000000000000000E+00 beta (00000186)=0.142074280328976E+02 gamma(00000186)=0.142074280328976E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 186 z1= 1 -.212648019337198E-03 0.000000000000000E+00 z1= 2 0.193943348297592E-06 0.000000000000000E+00 z1= 3 -.154535381365474E-06 0.000000000000000E+00 alpha(00000186)=0.000000000000000E+00 beta (00000187)=0.128286910759076E+02 gamma(00000187)=0.128286910759076E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 187 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000187)=0.000000000000000E+00 beta (00000188)=0.132173735044249E+02 gamma(00000188)=0.132173735044249E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 188 z1= 1 0.247098644040279E-03 0.000000000000000E+00 z1= 2 -.198338889665760E-06 0.000000000000000E+00 z1= 3 0.137718832952949E-06 0.000000000000000E+00 alpha(00000188)=0.000000000000000E+00 beta (00000189)=0.128569760245188E+02 gamma(00000189)=0.128569760245188E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 189 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000189)=0.000000000000000E+00 beta (00000190)=0.142159997929139E+02 gamma(00000190)=0.142159997929139E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 190 z1= 1 -.240835609325853E-03 0.000000000000000E+00 z1= 2 0.187715103076164E-06 0.000000000000000E+00 z1= 3 -.106640251888306E-06 0.000000000000000E+00 alpha(00000190)=0.000000000000000E+00 beta (00000191)=0.126038708010997E+02 gamma(00000191)=0.126038708010997E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 191 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000191)=0.000000000000000E+00 beta (00000192)=0.136580157234933E+02 gamma(00000192)=0.136580157234933E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 192 z1= 1 0.205643669349035E-03 0.000000000000000E+00 z1= 2 -.181994503301031E-06 0.000000000000000E+00 z1= 3 0.819460582982445E-07 0.000000000000000E+00 alpha(00000192)=0.000000000000000E+00 beta (00000193)=0.126334552918285E+02 gamma(00000193)=0.126334552918285E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 193 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000193)=0.000000000000000E+00 beta (00000194)=0.129256759985322E+02 gamma(00000194)=0.129256759985322E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 194 z1= 1 -.178812209002923E-03 0.000000000000000E+00 z1= 2 0.186385699840232E-06 0.000000000000000E+00 z1= 3 -.606323115749760E-07 0.000000000000000E+00 alpha(00000194)=0.000000000000000E+00 beta (00000195)=0.131621010892058E+02 gamma(00000195)=0.131621010892058E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 195 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000195)=0.000000000000000E+00 beta (00000196)=0.138486997194446E+02 gamma(00000196)=0.138486997194446E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 196 z1= 1 0.981440730796479E-04 0.000000000000000E+00 z1= 2 -.184036144220724E-06 0.000000000000000E+00 z1= 3 0.437025833736676E-07 0.000000000000000E+00 alpha(00000196)=0.000000000000000E+00 beta (00000197)=0.133176884431066E+02 gamma(00000197)=0.133176884431066E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 197 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000197)=0.000000000000000E+00 beta (00000198)=0.140086772531524E+02 gamma(00000198)=0.140086772531524E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 198 z1= 1 0.656751468213115E-04 0.000000000000000E+00 z1= 2 0.182184145222988E-06 0.000000000000000E+00 z1= 3 -.280646175282407E-07 0.000000000000000E+00 alpha(00000198)=0.000000000000000E+00 beta (00000199)=0.126231003617748E+02 gamma(00000199)=0.126231003617748E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 199 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000199)=0.000000000000000E+00 beta (00000200)=0.135471335089478E+02 gamma(00000200)=0.135471335089478E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 200 z1= 1 -.293501349540998E-03 0.000000000000000E+00 z1= 2 -.178158493364250E-06 0.000000000000000E+00 z1= 3 0.185012787688862E-07 0.000000000000000E+00 alpha(00000200)=0.000000000000000E+00 beta (00000201)=0.121664408763491E+02 gamma(00000201)=0.121664408763491E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 201 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000201)=0.000000000000000E+00 beta (00000202)=0.137621106753768E+02 gamma(00000202)=0.137621106753768E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 202 z1= 1 0.484315610250117E-03 0.000000000000000E+00 z1= 2 0.165815405853403E-06 0.000000000000000E+00 z1= 3 -.148522963434221E-07 0.000000000000000E+00 alpha(00000202)=0.000000000000000E+00 beta (00000203)=0.128304979697387E+02 gamma(00000203)=0.128304979697387E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 203 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000203)=0.000000000000000E+00 beta (00000204)=0.137473275907460E+02 gamma(00000204)=0.137473275907460E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 204 z1= 1 -.647444766481908E-03 0.000000000000000E+00 z1= 2 -.162513153555838E-06 0.000000000000000E+00 z1= 3 0.133326433076350E-07 0.000000000000000E+00 alpha(00000204)=0.000000000000000E+00 beta (00000205)=0.121748284784137E+02 gamma(00000205)=0.121748284784137E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 205 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000205)=0.000000000000000E+00 beta (00000206)=0.135409147156759E+02 gamma(00000206)=0.135409147156759E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 206 z1= 1 0.682093415162177E-03 0.000000000000000E+00 z1= 2 0.153498582945895E-06 0.000000000000000E+00 z1= 3 -.217187198789728E-07 0.000000000000000E+00 alpha(00000206)=0.000000000000000E+00 beta (00000207)=0.125235287205799E+02 gamma(00000207)=0.125235287205799E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 207 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000207)=0.000000000000000E+00 beta (00000208)=0.134816796514963E+02 gamma(00000208)=0.134816796514963E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 208 z1= 1 -.698709622209165E-03 0.000000000000000E+00 z1= 2 -.152087936260495E-06 0.000000000000000E+00 z1= 3 0.393764019950395E-07 0.000000000000000E+00 alpha(00000208)=0.000000000000000E+00 beta (00000209)=0.124235739689957E+02 gamma(00000209)=0.124235739689957E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 209 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000209)=0.000000000000000E+00 beta (00000210)=0.133912962090693E+02 gamma(00000210)=0.133912962090693E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 210 z1= 1 0.757084378759544E-03 0.000000000000000E+00 z1= 2 0.151289117545327E-06 0.000000000000000E+00 z1= 3 -.647390668658985E-07 0.000000000000000E+00 alpha(00000210)=0.000000000000000E+00 beta (00000211)=0.132521065109816E+02 gamma(00000211)=0.132521065109816E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 211 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000211)=0.000000000000000E+00 beta (00000212)=0.130575405965000E+02 gamma(00000212)=0.130575405965000E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 212 z1= 1 -.799336507812878E-03 0.000000000000000E+00 z1= 2 -.162167146633939E-06 0.000000000000000E+00 z1= 3 0.951403648242338E-07 0.000000000000000E+00 alpha(00000212)=0.000000000000000E+00 beta (00000213)=0.121344279379473E+02 gamma(00000213)=0.121344279379473E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 213 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000213)=0.000000000000000E+00 beta (00000214)=0.136940843318394E+02 gamma(00000214)=0.136940843318394E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 214 z1= 1 0.546982637126137E-03 0.000000000000000E+00 z1= 2 0.151518761492414E-06 0.000000000000000E+00 z1= 3 -.115699691023512E-06 0.000000000000000E+00 alpha(00000214)=0.000000000000000E+00 beta (00000215)=0.130546409821208E+02 gamma(00000215)=0.130546409821208E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 215 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000215)=0.000000000000000E+00 beta (00000216)=0.139907482284525E+02 gamma(00000216)=0.139907482284525E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 216 z1= 1 -.111392180416224E-03 0.000000000000000E+00 z1= 2 -.148487349212363E-06 0.000000000000000E+00 z1= 3 0.127252713394096E-06 0.000000000000000E+00 alpha(00000216)=0.000000000000000E+00 beta (00000217)=0.131053415647760E+02 gamma(00000217)=0.131053415647760E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 217 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000217)=0.000000000000000E+00 beta (00000218)=0.136145374249347E+02 gamma(00000218)=0.136145374249347E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 218 z1= 1 -.470313012322164E-03 0.000000000000000E+00 z1= 2 0.149408324941636E-06 0.000000000000000E+00 z1= 3 -.143289440843880E-06 0.000000000000000E+00 alpha(00000218)=0.000000000000000E+00 beta (00000219)=0.130737071808725E+02 gamma(00000219)=0.130737071808725E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 219 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000219)=0.000000000000000E+00 beta (00000220)=0.137872322088298E+02 gamma(00000220)=0.137872322088298E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 220 z1= 1 0.106678547262229E-02 0.000000000000000E+00 z1= 2 -.147245274129387E-06 0.000000000000000E+00 z1= 3 0.158630138211136E-06 0.000000000000000E+00 alpha(00000220)=0.000000000000000E+00 beta (00000221)=0.128028729425249E+02 gamma(00000221)=0.128028729425249E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 221 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000221)=0.000000000000000E+00 beta (00000222)=0.137338319937205E+02 gamma(00000222)=0.137338319937205E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 222 z1= 1 -.155533964537839E-02 0.000000000000000E+00 z1= 2 0.142393558758567E-06 0.000000000000000E+00 z1= 3 -.166762981017028E-06 0.000000000000000E+00 alpha(00000222)=0.000000000000000E+00 beta (00000223)=0.122029775233881E+02 gamma(00000223)=0.122029775233881E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 223 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000223)=0.000000000000000E+00 beta (00000224)=0.131574274297563E+02 gamma(00000224)=0.131574274297563E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 224 z1= 1 0.194541789334633E-02 0.000000000000000E+00 z1= 2 -.137645554696385E-06 0.000000000000000E+00 z1= 3 0.182092819905671E-06 0.000000000000000E+00 alpha(00000224)=0.000000000000000E+00 beta (00000225)=0.121479987041973E+02 gamma(00000225)=0.121479987041973E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 225 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000225)=0.000000000000000E+00 beta (00000226)=0.137842001652039E+02 gamma(00000226)=0.137842001652039E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 226 z1= 1 -.212626188225000E-02 0.000000000000000E+00 z1= 2 0.127314196222798E-06 0.000000000000000E+00 z1= 3 -.173652969123094E-06 0.000000000000000E+00 alpha(00000226)=0.000000000000000E+00 beta (00000227)=0.128716878749170E+02 gamma(00000227)=0.128716878749170E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 227 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000227)=0.000000000000000E+00 beta (00000228)=0.133599363502765E+02 gamma(00000228)=0.133599363502765E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 228 z1= 1 0.235187428130922E-02 0.000000000000000E+00 z1= 2 -.128118913689940E-06 0.000000000000000E+00 z1= 3 0.187860460395823E-06 0.000000000000000E+00 alpha(00000228)=0.000000000000000E+00 beta (00000229)=0.126508902308630E+02 gamma(00000229)=0.126508902308630E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 229 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000229)=0.000000000000000E+00 beta (00000230)=0.130544757158440E+02 gamma(00000230)=0.130544757158440E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 230 z1= 1 -.250687321305249E-02 0.000000000000000E+00 z1= 2 0.128489246300004E-06 0.000000000000000E+00 z1= 3 -.210253233790870E-06 0.000000000000000E+00 alpha(00000230)=0.000000000000000E+00 beta (00000231)=0.127900861942173E+02 gamma(00000231)=0.127900861942173E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 231 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000231)=0.000000000000000E+00 beta (00000232)=0.139958221715781E+02 gamma(00000232)=0.139958221715781E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 232 z1= 1 0.239197654675214E-02 0.000000000000000E+00 z1= 2 -.120536853965084E-06 0.000000000000000E+00 z1= 3 0.212134058157564E-06 0.000000000000000E+00 alpha(00000232)=0.000000000000000E+00 beta (00000233)=0.131324616475404E+02 gamma(00000233)=0.131324616475404E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 233 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000233)=0.000000000000000E+00 beta (00000234)=0.136723075124166E+02 gamma(00000234)=0.136723075124166E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 234 z1= 1 -.234316136573133E-02 0.000000000000000E+00 z1= 2 0.118020464585228E-06 0.000000000000000E+00 z1= 3 -.225486028916026E-06 0.000000000000000E+00 alpha(00000234)=0.000000000000000E+00 beta (00000235)=0.130063426512743E+02 gamma(00000235)=0.130063426512743E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 235 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000235)=0.000000000000000E+00 beta (00000236)=0.136793802202269E+02 gamma(00000236)=0.136793802202269E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 236 z1= 1 0.220556549552207E-02 0.000000000000000E+00 z1= 2 -.113921907556741E-06 0.000000000000000E+00 z1= 3 0.239061506860364E-06 0.000000000000000E+00 alpha(00000236)=0.000000000000000E+00 beta (00000237)=0.129605185589907E+02 gamma(00000237)=0.129605185589907E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 237 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000237)=0.000000000000000E+00 beta (00000238)=0.135509208391064E+02 gamma(00000238)=0.135509208391064E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 238 z1= 1 -.200615154803824E-02 0.000000000000000E+00 z1= 2 0.110301943675138E-06 0.000000000000000E+00 z1= 3 -.265058327995101E-06 0.000000000000000E+00 alpha(00000238)=0.000000000000000E+00 beta (00000239)=0.129572483704416E+02 gamma(00000239)=0.129572483704416E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 239 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000239)=0.000000000000000E+00 beta (00000240)=0.141677962060513E+02 gamma(00000240)=0.141677962060513E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 240 z1= 1 0.177698330067725E-02 0.000000000000000E+00 z1= 2 -.101606426234876E-06 0.000000000000000E+00 z1= 3 0.274525125774656E-06 0.000000000000000E+00 alpha(00000240)=0.000000000000000E+00 beta (00000241)=0.127858745085967E+02 gamma(00000241)=0.127858745085967E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 241 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000241)=0.000000000000000E+00 beta (00000242)=0.137129376251785E+02 gamma(00000242)=0.137129376251785E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 242 z1= 1 -.158887645601599E-02 0.000000000000000E+00 z1= 2 0.951923843564703E-07 0.000000000000000E+00 z1= 3 -.279176133751574E-06 0.000000000000000E+00 alpha(00000242)=0.000000000000000E+00 beta (00000243)=0.128810618639309E+02 gamma(00000243)=0.128810618639309E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 243 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000243)=0.000000000000000E+00 beta (00000244)=0.129023913738268E+02 gamma(00000244)=0.129023913738268E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 244 z1= 1 0.153736995470433E-02 0.000000000000000E+00 z1= 2 -.954998572754492E-07 0.000000000000000E+00 z1= 3 0.306960244322581E-06 0.000000000000000E+00 alpha(00000244)=0.000000000000000E+00 beta (00000245)=0.122178630568309E+02 gamma(00000245)=0.122178630568309E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 245 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000245)=0.000000000000000E+00 beta (00000246)=0.134655976966650E+02 gamma(00000246)=0.134655976966650E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 246 z1= 1 -.138154507189821E-02 0.000000000000000E+00 z1= 2 0.876565139013626E-07 0.000000000000000E+00 z1= 3 -.291826510221403E-06 0.000000000000000E+00 alpha(00000246)=0.000000000000000E+00 beta (00000247)=0.123261764894380E+02 gamma(00000247)=0.123261764894380E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 247 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000247)=0.000000000000000E+00 beta (00000248)=0.135306341252093E+02 gamma(00000248)=0.135306341252093E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 248 z1= 1 0.129950817977271E-02 0.000000000000000E+00 z1= 2 -.806947245595227E-07 0.000000000000000E+00 z1= 3 0.272817703902257E-06 0.000000000000000E+00 alpha(00000248)=0.000000000000000E+00 beta (00000249)=0.130329880195322E+02 gamma(00000249)=0.130329880195322E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 249 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000249)=0.000000000000000E+00 beta (00000250)=0.133723218174020E+02 gamma(00000250)=0.133723218174020E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 250 z1= 1 -.133837821079362E-02 0.000000000000000E+00 z1= 2 0.787162370728331E-07 0.000000000000000E+00 z1= 3 -.282268701295150E-06 0.000000000000000E+00 alpha(00000250)=0.000000000000000E+00 beta (00000251)=0.125956755443696E+02 gamma(00000251)=0.125956755443696E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 251 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000251)=0.000000000000000E+00 beta (00000252)=0.136070109906980E+02 gamma(00000252)=0.136070109906980E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 252 z1= 1 0.138846310701296E-02 0.000000000000000E+00 z1= 2 -.740806150876031E-07 0.000000000000000E+00 z1= 3 0.255377038513045E-06 0.000000000000000E+00 alpha(00000252)=0.000000000000000E+00 beta (00000253)=0.127858735752091E+02 gamma(00000253)=0.127858735752091E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 253 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000253)=0.000000000000000E+00 beta (00000254)=0.132358067792676E+02 gamma(00000254)=0.132358067792676E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 254 z1= 1 -.153715145409816E-02 0.000000000000000E+00 z1= 2 0.739261674658105E-07 0.000000000000000E+00 z1= 3 -.234169774825923E-06 0.000000000000000E+00 alpha(00000254)=0.000000000000000E+00 beta (00000255)=0.121427532352047E+02 gamma(00000255)=0.121427532352047E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 255 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000255)=0.000000000000000E+00 beta (00000256)=0.143751588964862E+02 gamma(00000256)=0.143751588964862E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 256 z1= 1 0.146835139836322E-02 0.000000000000000E+00 z1= 2 -.643809068606640E-07 0.000000000000000E+00 z1= 3 0.198376263473477E-06 0.000000000000000E+00 alpha(00000256)=0.000000000000000E+00 beta (00000257)=0.125263261777116E+02 gamma(00000257)=0.125263261777116E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 257 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000257)=0.000000000000000E+00 beta (00000258)=0.133616903364817E+02 gamma(00000258)=0.133616903364817E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 258 z1= 1 -.169137015810320E-02 0.000000000000000E+00 z1= 2 0.618999133842474E-07 0.000000000000000E+00 z1= 3 -.175788644939004E-06 0.000000000000000E+00 alpha(00000258)=0.000000000000000E+00 beta (00000259)=0.127923815941705E+02 gamma(00000259)=0.127923815941705E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 259 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000259)=0.000000000000000E+00 beta (00000260)=0.137669591311007E+02 gamma(00000260)=0.137669591311007E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 260 z1= 1 0.192263839975063E-02 0.000000000000000E+00 z1= 2 -.608171835340260E-07 0.000000000000000E+00 z1= 3 0.151966435412592E-06 0.000000000000000E+00 alpha(00000260)=0.000000000000000E+00 beta (00000261)=0.126234904665235E+02 gamma(00000261)=0.126234904665235E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 261 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000261)=0.000000000000000E+00 beta (00000262)=0.138366526098677E+02 gamma(00000262)=0.138366526098677E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 262 z1= 1 -.210623379694042E-02 0.000000000000000E+00 z1= 2 0.585562512866143E-07 0.000000000000000E+00 z1= 3 -.130141346935770E-06 0.000000000000000E+00 alpha(00000262)=0.000000000000000E+00 beta (00000263)=0.128959890639816E+02 gamma(00000263)=0.128959890639816E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 263 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000263)=0.000000000000000E+00 beta (00000264)=0.133015508543597E+02 gamma(00000264)=0.133015508543597E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 264 z1= 1 0.231918177600214E-02 0.000000000000000E+00 z1= 2 -.577221581261889E-07 0.000000000000000E+00 z1= 3 0.121577988270371E-06 0.000000000000000E+00 alpha(00000264)=0.000000000000000E+00 beta (00000265)=0.130100458238767E+02 gamma(00000265)=0.130100458238767E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 265 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000265)=0.000000000000000E+00 beta (00000266)=0.135350597549899E+02 gamma(00000266)=0.135350597549899E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 266 z1= 1 -.237160256204784E-02 0.000000000000000E+00 z1= 2 0.571738097308525E-07 0.000000000000000E+00 z1= 3 -.115275215886506E-06 0.000000000000000E+00 alpha(00000266)=0.000000000000000E+00 beta (00000267)=0.128615045177653E+02 gamma(00000267)=0.128615045177653E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 267 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000267)=0.000000000000000E+00 beta (00000268)=0.133347929687213E+02 gamma(00000268)=0.133347929687213E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 268 z1= 1 0.250978113455906E-02 0.000000000000000E+00 z1= 2 -.566935188508685E-07 0.000000000000000E+00 z1= 3 0.106138132951517E-06 0.000000000000000E+00 alpha(00000268)=0.000000000000000E+00 beta (00000269)=0.121018682788062E+02 gamma(00000269)=0.121018682788062E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 269 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000269)=0.000000000000000E+00 beta (00000270)=0.135291829677773E+02 gamma(00000270)=0.135291829677773E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 270 z1= 1 -.244010030527314E-02 0.000000000000000E+00 z1= 2 0.522899288807679E-07 0.000000000000000E+00 z1= 3 -.983717885060399E-07 0.000000000000000E+00 alpha(00000270)=0.000000000000000E+00 beta (00000271)=0.125622475291078E+02 gamma(00000271)=0.125622475291078E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 271 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000271)=0.000000000000000E+00 beta (00000272)=0.139105942758871E+02 gamma(00000272)=0.139105942758871E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 272 z1= 1 0.237698149966202E-02 0.000000000000000E+00 z1= 2 -.478747146231973E-07 0.000000000000000E+00 z1= 3 0.101177062728159E-06 0.000000000000000E+00 alpha(00000272)=0.000000000000000E+00 beta (00000273)=0.128218390683523E+02 gamma(00000273)=0.128218390683523E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 273 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000273)=0.000000000000000E+00 beta (00000274)=0.138030618402839E+02 gamma(00000274)=0.138030618402839E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 274 z1= 1 -.232001589884060E-02 0.000000000000000E+00 z1= 2 0.432615393335112E-07 0.000000000000000E+00 z1= 3 -.110397590453938E-06 0.000000000000000E+00 alpha(00000274)=0.000000000000000E+00 beta (00000275)=0.131283520091613E+02 gamma(00000275)=0.131283520091613E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 275 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000275)=0.000000000000000E+00 beta (00000276)=0.134506366302787E+02 gamma(00000276)=0.134506366302787E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 276 z1= 1 0.237955553334408E-02 0.000000000000000E+00 z1= 2 -.411789537243384E-07 0.000000000000000E+00 z1= 3 0.131889670752436E-06 0.000000000000000E+00 alpha(00000276)=0.000000000000000E+00 beta (00000277)=0.120983732815587E+02 gamma(00000277)=0.120983732815587E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 277 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000277)=0.000000000000000E+00 beta (00000278)=0.140362666565433E+02 gamma(00000278)=0.140362666565433E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 278 z1= 1 -.218942455758835E-02 0.000000000000000E+00 z1= 2 0.351221885073680E-07 0.000000000000000E+00 z1= 3 -.147278848050265E-06 0.000000000000000E+00 alpha(00000278)=0.000000000000000E+00 beta (00000279)=0.128343835804782E+02 gamma(00000279)=0.128343835804782E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 279 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000279)=0.000000000000000E+00 beta (00000280)=0.132035214475563E+02 gamma(00000280)=0.132035214475563E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 280 z1= 1 0.224740248939225E-02 0.000000000000000E+00 z1= 2 -.332798482248660E-07 0.000000000000000E+00 z1= 3 0.177597056673004E-06 0.000000000000000E+00 alpha(00000280)=0.000000000000000E+00 beta (00000281)=0.126296333453200E+02 gamma(00000281)=0.126296333453200E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 281 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000281)=0.000000000000000E+00 beta (00000282)=0.131165141731973E+02 gamma(00000282)=0.131165141731973E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 282 z1= 1 -.230874792367584E-02 0.000000000000000E+00 z1= 2 0.308811972998466E-07 0.000000000000000E+00 z1= 3 -.200175157760263E-06 0.000000000000000E+00 alpha(00000282)=0.000000000000000E+00 beta (00000283)=0.131275640949716E+02 gamma(00000283)=0.131275640949716E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 283 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000283)=0.000000000000000E+00 beta (00000284)=0.143339295833494E+02 gamma(00000284)=0.143339295833494E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 284 z1= 1 0.225772835178821E-02 0.000000000000000E+00 z1= 2 -.253418888400067E-07 0.000000000000000E+00 z1= 3 0.216531684268538E-06 0.000000000000000E+00 alpha(00000284)=0.000000000000000E+00 beta (00000285)=0.125045257001190E+02 gamma(00000285)=0.125045257001190E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 285 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000285)=0.000000000000000E+00 beta (00000286)=0.132262139925092E+02 gamma(00000286)=0.132262139925092E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 286 z1= 1 -.229640599901062E-02 0.000000000000000E+00 z1= 2 0.192690369337639E-07 0.000000000000000E+00 z1= 3 -.241805749138038E-06 0.000000000000000E+00 alpha(00000286)=0.000000000000000E+00 beta (00000287)=0.120364936591828E+02 gamma(00000287)=0.120364936591828E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 287 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000287)=0.000000000000000E+00 beta (00000288)=0.137286013775696E+02 gamma(00000288)=0.137286013775696E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 288 z1= 1 0.220302959859991E-02 0.000000000000000E+00 z1= 2 -.128653721157349E-07 0.000000000000000E+00 z1= 3 0.252305024099468E-06 0.000000000000000E+00 alpha(00000288)=0.000000000000000E+00 beta (00000289)=0.130404994825630E+02 gamma(00000289)=0.130404994825630E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 289 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000289)=0.000000000000000E+00 beta (00000290)=0.131657001019297E+02 gamma(00000290)=0.131657001019297E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 290 z1= 1 -.232324999192833E-02 0.000000000000000E+00 z1= 2 0.809257280501643E-08 0.000000000000000E+00 z1= 3 -.298760898674501E-06 0.000000000000000E+00 alpha(00000290)=0.000000000000000E+00 beta (00000291)=0.126882646964990E+02 gamma(00000291)=0.126882646964990E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 291 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000291)=0.000000000000000E+00 beta (00000292)=0.143987653986217E+02 gamma(00000292)=0.143987653986217E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 292 z1= 1 0.212985065998592E-02 0.000000000000000E+00 z1= 2 -.239880824362201E-08 0.000000000000000E+00 z1= 3 0.304989544167543E-06 0.000000000000000E+00 alpha(00000292)=0.000000000000000E+00 beta (00000293)=0.126193545620068E+02 gamma(00000293)=0.126193545620068E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 293 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000293)=0.000000000000000E+00 beta (00000294)=0.129214278847210E+02 gamma(00000294)=0.129214278847210E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 294 z1= 1 -.208169900485867E-02 0.000000000000000E+00 z1= 2 -.341357545181886E-08 0.000000000000000E+00 z1= 3 -.342952300989548E-06 0.000000000000000E+00 alpha(00000294)=0.000000000000000E+00 beta (00000295)=0.127214621687505E+02 gamma(00000295)=0.127214621687505E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 295 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000295)=0.000000000000000E+00 beta (00000296)=0.133270749069501E+02 gamma(00000296)=0.133270749069501E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 296 z1= 1 0.198537026544063E-02 0.000000000000000E+00 z1= 2 0.648775664267853E-08 0.000000000000000E+00 z1= 3 0.355610196433155E-06 0.000000000000000E+00 alpha(00000296)=0.000000000000000E+00 beta (00000297)=0.131105742219339E+02 gamma(00000297)=0.131105742219339E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 297 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000297)=0.000000000000000E+00 beta (00000298)=0.140224501565408E+02 gamma(00000298)=0.140224501565408E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 298 z1= 1 -.195920111139871E-02 0.000000000000000E+00 z1= 2 -.905068767327599E-08 0.000000000000000E+00 z1= 3 -.353597841529782E-06 0.000000000000000E+00 alpha(00000298)=0.000000000000000E+00 beta (00000299)=0.121723028691730E+02 gamma(00000299)=0.121723028691730E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 299 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000299)=0.000000000000000E+00 beta (00000300)=0.140899126817585E+02 gamma(00000300)=0.140899126817585E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 300 z1= 1 0.188316042591305E-02 0.000000000000000E+00 z1= 2 0.109561492833872E-07 0.000000000000000E+00 z1= 3 0.322937651920925E-06 0.000000000000000E+00 alpha(00000300)=0.000000000000000E+00 beta (00000301)=0.124135588646149E+02 gamma(00000301)=0.124135588646149E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 301 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000301)=0.000000000000000E+00 beta (00000302)=0.133578988083735E+02 gamma(00000302)=0.133578988083735E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 302 z1= 1 -.193500792734599E-02 0.000000000000000E+00 z1= 2 -.161301198385502E-07 0.000000000000000E+00 z1= 3 -.320318956036113E-06 0.000000000000000E+00 alpha(00000302)=0.000000000000000E+00 beta (00000303)=0.125625344347019E+02 gamma(00000303)=0.125625344347019E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 303 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000303)=0.000000000000000E+00 beta (00000304)=0.142297843252317E+02 gamma(00000304)=0.142297843252317E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 304 z1= 1 0.175266687914688E-02 0.000000000000000E+00 z1= 2 0.197490197585172E-07 0.000000000000000E+00 z1= 3 0.310206548583144E-06 0.000000000000000E+00 alpha(00000304)=0.000000000000000E+00 beta (00000305)=0.128701405730736E+02 gamma(00000305)=0.128701405730736E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 305 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000305)=0.000000000000000E+00 beta (00000306)=0.136715781480988E+02 gamma(00000306)=0.136715781480988E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 306 z1= 1 -.172429453325793E-02 0.000000000000000E+00 z1= 2 -.253196528498308E-07 0.000000000000000E+00 z1= 3 -.316906835421088E-06 0.000000000000000E+00 alpha(00000306)=0.000000000000000E+00 beta (00000307)=0.130511347081179E+02 gamma(00000307)=0.130511347081179E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 307 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000307)=0.000000000000000E+00 beta (00000308)=0.134136042856718E+02 gamma(00000308)=0.134136042856718E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 308 z1= 1 0.173725674215654E-02 0.000000000000000E+00 z1= 2 0.271952999403823E-07 0.000000000000000E+00 z1= 3 0.315115883210172E-06 0.000000000000000E+00 alpha(00000308)=0.000000000000000E+00 beta (00000309)=0.131023957327789E+02 gamma(00000309)=0.131023957327789E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 309 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000309)=0.000000000000000E+00 beta (00000310)=0.132548964797693E+02 gamma(00000310)=0.132548964797693E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 310 z1= 1 -.174191923941912E-02 0.000000000000000E+00 z1= 2 -.311308740553540E-07 0.000000000000000E+00 z1= 3 -.312078099528993E-06 0.000000000000000E+00 alpha(00000310)=0.000000000000000E+00 beta (00000311)=0.124095397701056E+02 gamma(00000311)=0.124095397701056E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 311 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000311)=0.000000000000000E+00 beta (00000312)=0.130929287512140E+02 gamma(00000312)=0.130929287512140E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 312 z1= 1 0.156009259100743E-02 0.000000000000000E+00 z1= 2 0.337201993421982E-07 0.000000000000000E+00 z1= 3 0.299572905754594E-06 0.000000000000000E+00 alpha(00000312)=0.000000000000000E+00 beta (00000313)=0.121153351448113E+02 gamma(00000313)=0.121153351448113E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 313 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000313)=0.000000000000000E+00 beta (00000314)=0.134746658728035E+02 gamma(00000314)=0.134746658728035E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 314 z1= 1 -.122500151771435E-02 0.000000000000000E+00 z1= 2 -.383710784329031E-07 0.000000000000000E+00 z1= 3 -.295885599136189E-06 0.000000000000000E+00 alpha(00000314)=0.000000000000000E+00 beta (00000315)=0.126361311692083E+02 gamma(00000315)=0.126361311692083E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 315 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000315)=0.000000000000000E+00 beta (00000316)=0.137668396928916E+02 gamma(00000316)=0.137668396928916E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 316 z1= 1 0.856272803046449E-03 0.000000000000000E+00 z1= 2 0.388792484322560E-07 0.000000000000000E+00 z1= 3 0.285014675522992E-06 0.000000000000000E+00 alpha(00000316)=0.000000000000000E+00 beta (00000317)=0.117416559561569E+02 gamma(00000317)=0.117416559561569E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 317 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000317)=0.000000000000000E+00 beta (00000318)=0.139797019125532E+02 gamma(00000318)=0.139797019125532E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 318 z1= 1 -.309320212790346E-03 0.000000000000000E+00 z1= 2 -.425475354462468E-07 0.000000000000000E+00 z1= 3 -.243958267800970E-06 0.000000000000000E+00 alpha(00000318)=0.000000000000000E+00 beta (00000319)=0.131906817016507E+02 gamma(00000319)=0.131906817016507E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 319 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000319)=0.000000000000000E+00 beta (00000320)=0.142027191331668E+02 gamma(00000320)=0.142027191331668E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 320 z1= 1 -.729662561611884E-04 0.000000000000000E+00 z1= 2 0.398545840602730E-07 0.000000000000000E+00 z1= 3 0.223794364161947E-06 0.000000000000000E+00 alpha(00000320)=0.000000000000000E+00 beta (00000321)=0.120918676534286E+02 gamma(00000321)=0.120918676534286E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 321 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000321)=0.000000000000000E+00 beta (00000322)=0.139008414917011E+02 gamma(00000322)=0.139008414917011E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 322 z1= 1 0.410714386833108E-03 0.000000000000000E+00 z1= 2 -.449231486918632E-07 0.000000000000000E+00 z1= 3 -.201733950701098E-06 0.000000000000000E+00 alpha(00000322)=0.000000000000000E+00 beta (00000323)=0.124485466059486E+02 gamma(00000323)=0.124485466059486E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 323 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000323)=0.000000000000000E+00 beta (00000324)=0.144297194459430E+02 gamma(00000324)=0.144297194459430E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 324 z1= 1 -.577846657343485E-03 0.000000000000000E+00 z1= 2 0.360715386694358E-07 0.000000000000000E+00 z1= 3 0.177591764248736E-06 0.000000000000000E+00 alpha(00000324)=0.000000000000000E+00 beta (00000325)=0.132885499579536E+02 gamma(00000325)=0.132885499579536E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 325 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000325)=0.000000000000000E+00 beta (00000326)=0.141975952926049E+02 gamma(00000326)=0.141975952926049E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 326 z1= 1 0.593802296618342E-03 0.000000000000000E+00 z1= 2 -.451480228981418E-07 0.000000000000000E+00 z1= 3 -.180614614963241E-06 0.000000000000000E+00 alpha(00000326)=0.000000000000000E+00 beta (00000327)=0.125294295842564E+02 gamma(00000327)=0.125294295842564E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 327 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000327)=0.000000000000000E+00 beta (00000328)=0.131328572843505E+02 gamma(00000328)=0.131328572843505E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 328 z1= 1 -.468621306243110E-03 0.000000000000000E+00 z1= 2 0.414686741967776E-07 0.000000000000000E+00 z1= 3 0.162167783007895E-06 0.000000000000000E+00 alpha(00000328)=0.000000000000000E+00 beta (00000329)=0.129816764453856E+02 gamma(00000329)=0.129816764453856E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 329 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000329)=0.000000000000000E+00 beta (00000330)=0.141161468574602E+02 gamma(00000330)=0.141161468574602E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 330 z1= 1 0.297227005100821E-03 0.000000000000000E+00 z1= 2 -.469124891099536E-07 0.000000000000000E+00 z1= 3 -.140481139523997E-06 0.000000000000000E+00 alpha(00000330)=0.000000000000000E+00 beta (00000331)=0.121455240220776E+02 gamma(00000331)=0.121455240220776E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 331 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000331)=0.000000000000000E+00 beta (00000332)=0.138368699450733E+02 gamma(00000332)=0.138368699450733E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 332 z1= 1 -.149690082768884E-03 0.000000000000000E+00 z1= 2 0.449414481202420E-07 0.000000000000000E+00 z1= 3 0.127209418829358E-06 0.000000000000000E+00 alpha(00000332)=0.000000000000000E+00 beta (00000333)=0.124397119058985E+02 gamma(00000333)=0.124397119058985E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 333 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000333)=0.000000000000000E+00 beta (00000334)=0.130461017660828E+02 gamma(00000334)=0.130461017660828E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 334 z1= 1 0.774174672788239E-04 0.000000000000000E+00 z1= 2 -.554630101689407E-07 0.000000000000000E+00 z1= 3 -.140415654176749E-06 0.000000000000000E+00 alpha(00000334)=0.000000000000000E+00 beta (00000335)=0.129555743416219E+02 gamma(00000335)=0.129555743416219E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 335 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000335)=0.000000000000000E+00 beta (00000336)=0.130421374999919E+02 gamma(00000336)=0.130421374999919E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 336 z1= 1 -.992548472548592E-04 0.000000000000000E+00 z1= 2 0.619964542637047E-07 0.000000000000000E+00 z1= 3 0.144650300548630E-06 0.000000000000000E+00 alpha(00000336)=0.000000000000000E+00 beta (00000337)=0.131182147413444E+02 gamma(00000337)=0.131182147413444E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 337 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000337)=0.000000000000000E+00 beta (00000338)=0.128688271553071E+02 gamma(00000338)=0.128688271553071E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 338 z1= 1 0.236198659857093E-03 0.000000000000000E+00 z1= 2 -.723800961249799E-07 0.000000000000000E+00 z1= 3 -.153266278406344E-06 0.000000000000000E+00 alpha(00000338)=0.000000000000000E+00 beta (00000339)=0.142107056139294E+02 gamma(00000339)=0.142107056139294E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 339 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000339)=0.000000000000000E+00 beta (00000340)=0.137007834448921E+02 gamma(00000340)=0.137007834448921E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 340 z1= 1 -.395294873095640E-03 0.000000000000000E+00 z1= 2 0.799620094001433E-07 0.000000000000000E+00 z1= 3 0.161807269601414E-06 0.000000000000000E+00 alpha(00000340)=0.000000000000000E+00 beta (00000341)=0.123133782867336E+02 gamma(00000341)=0.123133782867336E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 341 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000341)=0.000000000000000E+00 beta (00000342)=0.140827286834950E+02 gamma(00000342)=0.140827286834950E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 342 z1= 1 0.565678594412193E-03 0.000000000000000E+00 z1= 2 -.803207807075108E-07 0.000000000000000E+00 z1= 3 -.151953223793660E-06 0.000000000000000E+00 alpha(00000342)=0.000000000000000E+00 beta (00000343)=0.127819759869335E+02 gamma(00000343)=0.127819759869335E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 343 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000343)=0.000000000000000E+00 beta (00000344)=0.137431470870972E+02 gamma(00000344)=0.137431470870972E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 344 z1= 1 -.851634095901959E-03 0.000000000000000E+00 z1= 2 0.822297340930672E-07 0.000000000000000E+00 z1= 3 0.147830652505137E-06 0.000000000000000E+00 alpha(00000344)=0.000000000000000E+00 beta (00000345)=0.122396806549800E+02 gamma(00000345)=0.122396806549800E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 345 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000345)=0.000000000000000E+00 beta (00000346)=0.141424879055313E+02 gamma(00000346)=0.141424879055313E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 346 z1= 1 0.103547284039435E-02 0.000000000000000E+00 z1= 2 -.815560057959575E-07 0.000000000000000E+00 z1= 3 -.142481752796590E-06 0.000000000000000E+00 alpha(00000346)=0.000000000000000E+00 beta (00000347)=0.122393283651140E+02 gamma(00000347)=0.122393283651140E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 347 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000347)=0.000000000000000E+00 beta (00000348)=0.143511433505228E+02 gamma(00000348)=0.143511433505228E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 348 z1= 1 -.124008315045640E-02 0.000000000000000E+00 z1= 2 0.794336317989225E-07 0.000000000000000E+00 z1= 3 0.132514817792242E-06 0.000000000000000E+00 alpha(00000348)=0.000000000000000E+00 beta (00000349)=0.120264949566833E+02 gamma(00000349)=0.120264949566833E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 349 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000349)=0.000000000000000E+00 beta (00000350)=0.127205349588826E+02 gamma(00000350)=0.127205349588826E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 350 z1= 1 0.160500531804516E-02 0.000000000000000E+00 z1= 2 -.883526637528859E-07 0.000000000000000E+00 z1= 3 -.111031741938247E-06 0.000000000000000E+00 alpha(00000350)=0.000000000000000E+00 beta (00000351)=0.127837042630054E+02 gamma(00000351)=0.127837042630054E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 351 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000351)=0.000000000000000E+00 beta (00000352)=0.140172876960356E+02 gamma(00000352)=0.140172876960356E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 352 z1= 1 -.166781795282291E-02 0.000000000000000E+00 z1= 2 0.912308111824731E-07 0.000000000000000E+00 z1= 3 0.884674254340552E-07 0.000000000000000E+00 alpha(00000352)=0.000000000000000E+00 beta (00000353)=0.124536640603623E+02 gamma(00000353)=0.124536640603623E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 353 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000353)=0.000000000000000E+00 beta (00000354)=0.134441509431453E+02 gamma(00000354)=0.134441509431453E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 354 z1= 1 0.167863400570533E-02 0.000000000000000E+00 z1= 2 -.970300222456581E-07 0.000000000000000E+00 z1= 3 -.578930877620585E-07 0.000000000000000E+00 alpha(00000354)=0.000000000000000E+00 beta (00000355)=0.125789413335338E+02 gamma(00000355)=0.125789413335338E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 355 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000355)=0.000000000000000E+00 beta (00000356)=0.134620232932619E+02 gamma(00000356)=0.134620232932619E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 356 z1= 1 -.164556514287593E-02 0.000000000000000E+00 z1= 2 0.101877341671282E-06 0.000000000000000E+00 z1= 3 0.208620227677182E-07 0.000000000000000E+00 alpha(00000356)=0.000000000000000E+00 beta (00000357)=0.124464708159083E+02 gamma(00000357)=0.124464708159083E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 357 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000357)=0.000000000000000E+00 beta (00000358)=0.139960896636131E+02 gamma(00000358)=0.139960896636131E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 358 z1= 1 0.137479498565637E-02 0.000000000000000E+00 z1= 2 -.989392136673678E-07 0.000000000000000E+00 z1= 3 0.186158700486022E-07 0.000000000000000E+00 alpha(00000358)=0.000000000000000E+00 beta (00000359)=0.126726261084827E+02 gamma(00000359)=0.126726261084827E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 359 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000359)=0.000000000000000E+00 beta (00000360)=0.139392681729497E+02 gamma(00000360)=0.139392681729497E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 360 z1= 1 -.985831827879017E-03 0.000000000000000E+00 z1= 2 0.100573858095865E-06 0.000000000000000E+00 z1= 3 -.661172116539119E-07 0.000000000000000E+00 alpha(00000360)=0.000000000000000E+00 beta (00000361)=0.126816247241275E+02 gamma(00000361)=0.126816247241275E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 361 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000361)=0.000000000000000E+00 beta (00000362)=0.134458516301305E+02 gamma(00000362)=0.134458516301305E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 362 z1= 1 0.506392441103702E-03 0.000000000000000E+00 z1= 2 -.104836633455993E-06 0.000000000000000E+00 z1= 3 0.116630204028973E-06 0.000000000000000E+00 alpha(00000362)=0.000000000000000E+00 beta (00000363)=0.128757995277267E+02 gamma(00000363)=0.128757995277267E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 363 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000363)=0.000000000000000E+00 beta (00000364)=0.140216290409696E+02 gamma(00000364)=0.140216290409696E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 364 z1= 1 0.971437500091928E-04 0.000000000000000E+00 z1= 2 0.108258035241143E-06 0.000000000000000E+00 z1= 3 -.158404447705111E-06 0.000000000000000E+00 alpha(00000364)=0.000000000000000E+00 beta (00000365)=0.129568298966633E+02 gamma(00000365)=0.129568298966633E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 365 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000365)=0.000000000000000E+00 beta (00000366)=0.130215967518313E+02 gamma(00000366)=0.130215967518313E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 366 z1= 1 -.628259653326089E-03 0.000000000000000E+00 z1= 2 -.117149544925921E-06 0.000000000000000E+00 z1= 3 0.217757554896094E-06 0.000000000000000E+00 alpha(00000366)=0.000000000000000E+00 beta (00000367)=0.127364120799550E+02 gamma(00000367)=0.127364120799550E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 367 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000367)=0.000000000000000E+00 beta (00000368)=0.131500007565548E+02 gamma(00000368)=0.131500007565548E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 368 z1= 1 0.103719874450372E-02 0.000000000000000E+00 z1= 2 0.126510011494874E-06 0.000000000000000E+00 z1= 3 -.266518804247461E-06 0.000000000000000E+00 alpha(00000368)=0.000000000000000E+00 beta (00000369)=0.125976883558687E+02 gamma(00000369)=0.125976883558687E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 369 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000369)=0.000000000000000E+00 beta (00000370)=0.141034552504175E+02 gamma(00000370)=0.141034552504175E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 370 z1= 1 -.128793082274732E-02 0.000000000000000E+00 z1= 2 -.121401509813089E-06 0.000000000000000E+00 z1= 3 0.290894917601137E-06 0.000000000000000E+00 alpha(00000370)=0.000000000000000E+00 beta (00000371)=0.125951886261545E+02 gamma(00000371)=0.125951886261545E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 371 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000371)=0.000000000000000E+00 beta (00000372)=0.138035771564477E+02 gamma(00000372)=0.138035771564477E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 372 z1= 1 0.145082241850050E-02 0.000000000000000E+00 z1= 2 0.128118646953003E-06 0.000000000000000E+00 z1= 3 -.296645209790487E-06 0.000000000000000E+00 alpha(00000372)=0.000000000000000E+00 beta (00000373)=0.126539947656319E+02 gamma(00000373)=0.126539947656319E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 373 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000373)=0.000000000000000E+00 beta (00000374)=0.137356252488801E+02 gamma(00000374)=0.137356252488801E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 374 z1= 1 -.168687868646702E-02 0.000000000000000E+00 z1= 2 -.128741260577506E-06 0.000000000000000E+00 z1= 3 0.313217808222300E-06 0.000000000000000E+00 alpha(00000374)=0.000000000000000E+00 beta (00000375)=0.130423860528824E+02 gamma(00000375)=0.130423860528824E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 375 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000375)=0.000000000000000E+00 beta (00000376)=0.134059455444309E+02 gamma(00000376)=0.134059455444309E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 376 z1= 1 0.201180463546243E-02 0.000000000000000E+00 z1= 2 0.146482988768685E-06 0.000000000000000E+00 z1= 3 -.336892577201581E-06 0.000000000000000E+00 alpha(00000376)=0.000000000000000E+00 beta (00000377)=0.122114127914923E+02 gamma(00000377)=0.122114127914923E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 377 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000377)=0.000000000000000E+00 beta (00000378)=0.138776589150023E+02 gamma(00000378)=0.138776589150023E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 378 z1= 1 -.189827386402480E-02 0.000000000000000E+00 z1= 2 -.139742322732492E-06 0.000000000000000E+00 z1= 3 0.313686796123548E-06 0.000000000000000E+00 alpha(00000378)=0.000000000000000E+00 beta (00000379)=0.121592294952625E+02 gamma(00000379)=0.121592294952625E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 379 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000379)=0.000000000000000E+00 beta (00000380)=0.131640964853911E+02 gamma(00000380)=0.131640964853911E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 380 z1= 1 0.171941501591607E-02 0.000000000000000E+00 z1= 2 0.155912769386930E-06 0.000000000000000E+00 z1= 3 -.291241814362833E-06 0.000000000000000E+00 alpha(00000380)=0.000000000000000E+00 beta (00000381)=0.128748155170257E+02 gamma(00000381)=0.128748155170257E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 381 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000381)=0.000000000000000E+00 beta (00000382)=0.136497271561261E+02 gamma(00000382)=0.136497271561261E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 382 z1= 1 -.137800753398175E-02 0.000000000000000E+00 z1= 2 -.151491512818827E-06 0.000000000000000E+00 z1= 3 0.280818758598264E-06 0.000000000000000E+00 alpha(00000382)=0.000000000000000E+00 beta (00000383)=0.136741042795806E+02 gamma(00000383)=0.136741042795806E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 383 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000383)=0.000000000000000E+00 beta (00000384)=0.129454304305035E+02 gamma(00000384)=0.129454304305035E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 384 z1= 1 0.111404801574168E-02 0.000000000000000E+00 z1= 2 0.193998155254525E-06 0.000000000000000E+00 z1= 3 -.278516166551002E-06 0.000000000000000E+00 alpha(00000384)=0.000000000000000E+00 beta (00000385)=0.121459957648558E+02 gamma(00000385)=0.121459957648558E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 385 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000385)=0.000000000000000E+00 beta (00000386)=0.142742222637135E+02 gamma(00000386)=0.142742222637135E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 386 z1= 1 -.734353065143706E-03 0.000000000000000E+00 z1= 2 -.161141686402019E-06 0.000000000000000E+00 z1= 3 0.249139935192899E-06 0.000000000000000E+00 alpha(00000386)=0.000000000000000E+00 beta (00000387)=0.122927195599760E+02 gamma(00000387)=0.122927195599760E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 387 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000387)=0.000000000000000E+00 beta (00000388)=0.137763102788060E+02 gamma(00000388)=0.137763102788060E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 388 z1= 1 0.520422934632829E-03 0.000000000000000E+00 z1= 2 0.187160153123853E-06 0.000000000000000E+00 z1= 3 -.206061937596915E-06 0.000000000000000E+00 alpha(00000388)=0.000000000000000E+00 beta (00000389)=0.130614252670113E+02 gamma(00000389)=0.130614252670113E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 389 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000389)=0.000000000000000E+00 beta (00000390)=0.131757258033180E+02 gamma(00000390)=0.131757258033180E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 390 z1= 1 -.440013548720919E-03 0.000000000000000E+00 z1= 2 -.172582934148107E-06 0.000000000000000E+00 z1= 3 0.232394019395908E-06 0.000000000000000E+00 alpha(00000390)=0.000000000000000E+00 beta (00000391)=0.127386835184832E+02 gamma(00000391)=0.127386835184832E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 391 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000391)=0.000000000000000E+00 beta (00000392)=0.130591516078663E+02 gamma(00000392)=0.130591516078663E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 392 z1= 1 0.441950660094392E-03 0.000000000000000E+00 z1= 2 0.233260264639358E-06 0.000000000000000E+00 z1= 3 -.183780925551067E-06 0.000000000000000E+00 alpha(00000392)=0.000000000000000E+00 beta (00000393)=0.130974715124237E+02 gamma(00000393)=0.130974715124237E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 393 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000393)=0.000000000000000E+00 beta (00000394)=0.136811708759468E+02 gamma(00000394)=0.136811708759468E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 394 z1= 1 -.443322025065494E-03 0.000000000000000E+00 z1= 2 -.185313917014547E-06 0.000000000000000E+00 z1= 3 0.222009005146589E-06 0.000000000000000E+00 alpha(00000394)=0.000000000000000E+00 beta (00000395)=0.120623959278355E+02 gamma(00000395)=0.120623959278355E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 395 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000395)=0.000000000000000E+00 beta (00000396)=0.140851162055372E+02 gamma(00000396)=0.140851162055372E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 396 z1= 1 0.288823966019237E-03 0.000000000000000E+00 z1= 2 0.253043176346585E-06 0.000000000000000E+00 z1= 3 -.118665712745469E-06 0.000000000000000E+00 alpha(00000396)=0.000000000000000E+00 beta (00000397)=0.131149827676163E+02 gamma(00000397)=0.131149827676163E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 397 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000397)=0.000000000000000E+00 beta (00000398)=0.143726383823382E+02 gamma(00000398)=0.143726383823382E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 398 z1= 1 -.633849744380716E-04 0.000000000000000E+00 z1= 2 -.164548400793073E-06 0.000000000000000E+00 z1= 3 0.135456419297604E-06 0.000000000000000E+00 alpha(00000398)=0.000000000000000E+00 beta (00000399)=0.120291983855719E+02 gamma(00000399)=0.120291983855719E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 399 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000399)=0.000000000000000E+00 beta (00000400)=0.134249437707379E+02 gamma(00000400)=0.134249437707379E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 400 z1= 1 -.204985788959451E-03 0.000000000000000E+00 z1= 2 0.273556884588209E-06 0.000000000000000E+00 z1= 3 0.573098587705080E-08 0.000000000000000E+00 alpha(00000400)=0.000000000000000E+00 beta (00000401)=0.130994908756887E+02 gamma(00000401)=0.130994908756887E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 401 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000401)=0.000000000000000E+00 beta (00000402)=0.134859478202154E+02 gamma(00000402)=0.134859478202154E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 402 z1= 1 0.337986253075930E-03 0.000000000000000E+00 z1= 2 -.177038570929079E-06 0.000000000000000E+00 z1= 3 0.468099337885136E-07 0.000000000000000E+00 alpha(00000402)=0.000000000000000E+00 beta (00000403)=0.130763630238393E+02 gamma(00000403)=0.130763630238393E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 403 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000403)=0.000000000000000E+00 beta (00000404)=0.140318003696941E+02 gamma(00000404)=0.140318003696941E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 404 z1= 1 -.414588282303651E-03 0.000000000000000E+00 z1= 2 0.314609969737437E-06 0.000000000000000E+00 z1= 3 0.679382056217783E-07 0.000000000000000E+00 alpha(00000404)=0.000000000000000E+00 beta (00000405)=0.134598421263891E+02 gamma(00000405)=0.134598421263891E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 405 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000405)=0.000000000000000E+00 beta (00000406)=0.134284168580349E+02 gamma(00000406)=0.134284168580349E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 406 z1= 1 0.546586462297298E-03 0.000000000000000E+00 z1= 2 -.218740867759248E-06 0.000000000000000E+00 z1= 3 0.429311309305081E-08 0.000000000000000E+00 alpha(00000406)=0.000000000000000E+00 beta (00000407)=0.129168847852837E+02 gamma(00000407)=0.129168847852837E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 407 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000407)=0.000000000000000E+00 beta (00000408)=0.137625757463328E+02 gamma(00000408)=0.137625757463328E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 408 z1= 1 -.634603599609748E-03 0.000000000000000E+00 z1= 2 0.325880418457561E-06 0.000000000000000E+00 z1= 3 0.867005986687048E-07 0.000000000000000E+00 alpha(00000408)=0.000000000000000E+00 beta (00000409)=0.126683806962820E+02 gamma(00000409)=0.126683806962820E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 409 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000409)=0.000000000000000E+00 beta (00000410)=0.126951858654505E+02 gamma(00000410)=0.126951858654505E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 410 z1= 1 0.780913982643079E-03 0.000000000000000E+00 z1= 2 -.277297907073058E-06 0.000000000000000E+00 z1= 3 -.355664733399787E-07 0.000000000000000E+00 alpha(00000410)=0.000000000000000E+00 beta (00000411)=0.129390402280169E+02 gamma(00000411)=0.129390402280169E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 411 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000411)=0.000000000000000E+00 beta (00000412)=0.139561460225107E+02 gamma(00000412)=0.139561460225107E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 412 z1= 1 -.814977446367189E-03 0.000000000000000E+00 z1= 2 0.340663596025935E-06 0.000000000000000E+00 z1= 3 0.855022833165390E-07 0.000000000000000E+00 alpha(00000412)=0.000000000000000E+00 beta (00000413)=0.123141697858432E+02 gamma(00000413)=0.123141697858432E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 413 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000413)=0.000000000000000E+00 beta (00000414)=0.136875407935459E+02 gamma(00000414)=0.136875407935459E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 414 z1= 1 0.760014806563345E-03 0.000000000000000E+00 z1= 2 -.278861577733026E-06 0.000000000000000E+00 z1= 3 -.258049929965242E-07 0.000000000000000E+00 alpha(00000414)=0.000000000000000E+00 beta (00000415)=0.130354288202940E+02 gamma(00000415)=0.130354288202940E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 415 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000415)=0.000000000000000E+00 beta (00000416)=0.132102244866680E+02 gamma(00000416)=0.132102244866680E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 416 z1= 1 -.688523651618086E-03 0.000000000000000E+00 z1= 2 0.351418468658811E-06 0.000000000000000E+00 z1= 3 0.512479386320175E-07 0.000000000000000E+00 alpha(00000416)=0.000000000000000E+00 beta (00000417)=0.123306397031175E+02 gamma(00000417)=0.123306397031175E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 417 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000417)=0.000000000000000E+00 beta (00000418)=0.133718325523402E+02 gamma(00000418)=0.133718325523402E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 418 z1= 1 0.413626069778497E-03 0.000000000000000E+00 z1= 2 -.298066605513561E-06 0.000000000000000E+00 z1= 3 -.693016827274127E-08 0.000000000000000E+00 alpha(00000418)=0.000000000000000E+00 beta (00000419)=0.137335389989178E+02 gamma(00000419)=0.137335389989178E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 419 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000419)=0.000000000000000E+00 beta (00000420)=0.141135383705680E+02 gamma(00000420)=0.141135383705680E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 420 z1= 1 -.969964964698572E-04 0.000000000000000E+00 z1= 2 0.367057053364019E-06 0.000000000000000E+00 z1= 3 0.401835871850114E-07 0.000000000000000E+00 alpha(00000420)=0.000000000000000E+00 beta (00000421)=0.126120251492996E+02 gamma(00000421)=0.126120251492996E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 421 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000421)=0.000000000000000E+00 beta (00000422)=0.142489576883799E+02 gamma(00000422)=0.142489576883799E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 422 z1= 1 -.260771249906472E-03 0.000000000000000E+00 z1= 2 -.301148812744323E-06 0.000000000000000E+00 z1= 3 0.177191342853747E-08 0.000000000000000E+00 alpha(00000422)=0.000000000000000E+00 beta (00000423)=0.122621688884122E+02 gamma(00000423)=0.122621688884122E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 423 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000423)=0.000000000000000E+00 beta (00000424)=0.130753125685283E+02 gamma(00000424)=0.130753125685283E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 424 z1= 1 0.595559719117312E-03 0.000000000000000E+00 z1= 2 0.346710632166637E-06 0.000000000000000E+00 z1= 3 0.378190677903577E-07 0.000000000000000E+00 alpha(00000424)=0.000000000000000E+00 beta (00000425)=0.127677630070443E+02 gamma(00000425)=0.127677630070443E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 425 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000425)=0.000000000000000E+00 beta (00000426)=0.141545123494922E+02 gamma(00000426)=0.141545123494922E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 426 z1= 1 -.826143116629400E-03 0.000000000000000E+00 z1= 2 -.307508548771842E-06 0.000000000000000E+00 z1= 3 -.233809778866991E-07 0.000000000000000E+00 alpha(00000426)=0.000000000000000E+00 beta (00000427)=0.126305328076324E+02 gamma(00000427)=0.126305328076324E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 427 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000427)=0.000000000000000E+00 beta (00000428)=0.140023741399220E+02 gamma(00000428)=0.140023741399220E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 428 z1= 1 0.104951237134059E-02 0.000000000000000E+00 z1= 2 0.333543387219266E-06 0.000000000000000E+00 z1= 3 0.612136965150579E-07 0.000000000000000E+00 alpha(00000428)=0.000000000000000E+00 beta (00000429)=0.120481851901768E+02 gamma(00000429)=0.120481851901768E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 429 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000429)=0.000000000000000E+00 beta (00000430)=0.132403490364415E+02 gamma(00000430)=0.132403490364415E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 430 z1= 1 -.131614979403222E-02 0.000000000000000E+00 z1= 2 -.317885681559021E-06 0.000000000000000E+00 z1= 3 -.739508153344362E-07 0.000000000000000E+00 alpha(00000430)=0.000000000000000E+00 beta (00000431)=0.125686207189734E+02 gamma(00000431)=0.125686207189734E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 431 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000431)=0.000000000000000E+00 beta (00000432)=0.136173796443182E+02 gamma(00000432)=0.136173796443182E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 432 z1= 1 0.159578232845522E-02 0.000000000000000E+00 z1= 2 0.348715831099966E-06 0.000000000000000E+00 z1= 3 0.108639737680819E-06 0.000000000000000E+00 alpha(00000432)=0.000000000000000E+00 beta (00000433)=0.129125805276438E+02 gamma(00000433)=0.129125805276438E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 433 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000433)=0.000000000000000E+00 beta (00000434)=0.143179527568960E+02 gamma(00000434)=0.143179527568960E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 434 z1= 1 -.170548980329041E-02 0.000000000000000E+00 z1= 2 -.323030385392326E-06 0.000000000000000E+00 z1= 3 -.980775443490596E-07 0.000000000000000E+00 alpha(00000434)=0.000000000000000E+00 beta (00000435)=0.120667607146053E+02 gamma(00000435)=0.120667607146053E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 435 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000435)=0.000000000000000E+00 beta (00000436)=0.134765923035328E+02 gamma(00000436)=0.134765923035328E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 436 z1= 1 0.168331051768636E-02 0.000000000000000E+00 z1= 2 0.351027342147207E-06 0.000000000000000E+00 z1= 3 0.120166667862934E-06 0.000000000000000E+00 alpha(00000436)=0.000000000000000E+00 beta (00000437)=0.127937585422040E+02 gamma(00000437)=0.127937585422040E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 437 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000437)=0.000000000000000E+00 beta (00000438)=0.144134944614105E+02 gamma(00000438)=0.144134944614105E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 438 z1= 1 -.144906237115113E-02 0.000000000000000E+00 z1= 2 -.324291746051694E-06 0.000000000000000E+00 z1= 3 -.122590872484753E-06 0.000000000000000E+00 alpha(00000438)=0.000000000000000E+00 beta (00000439)=0.136440224705948E+02 gamma(00000439)=0.136440224705948E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 439 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000439)=0.000000000000000E+00 beta (00000440)=0.134358813743161E+02 gamma(00000440)=0.134358813743161E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 440 z1= 1 0.121817210977403E-02 0.000000000000000E+00 z1= 2 0.396506440618772E-06 0.000000000000000E+00 z1= 3 0.194145994414656E-06 0.000000000000000E+00 alpha(00000440)=0.000000000000000E+00 beta (00000441)=0.130823648187725E+02 gamma(00000441)=0.130823648187725E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 441 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000441)=0.000000000000000E+00 beta (00000442)=0.132267552216596E+02 gamma(00000442)=0.132267552216596E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 442 z1= 1 -.802061880579379E-03 0.000000000000000E+00 z1= 2 -.417606079877860E-06 0.000000000000000E+00 z1= 3 -.220655977217472E-06 0.000000000000000E+00 alpha(00000442)=0.000000000000000E+00 beta (00000443)=0.122206239156276E+02 gamma(00000443)=0.122206239156276E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 443 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000443)=0.000000000000000E+00 beta (00000444)=0.135680150319639E+02 gamma(00000444)=0.135680150319639E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 444 z1= 1 0.243338609639909E-03 0.000000000000000E+00 z1= 2 0.428718405311602E-06 0.000000000000000E+00 z1= 3 0.230372647163279E-06 0.000000000000000E+00 alpha(00000444)=0.000000000000000E+00 beta (00000445)=0.131982437666925E+02 gamma(00000445)=0.131982437666925E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 445 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000445)=0.000000000000000E+00 beta (00000446)=0.133144872793517E+02 gamma(00000446)=0.133144872793517E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 446 z1= 1 0.255893595873910E-03 0.000000000000000E+00 z1= 2 -.461364453547414E-06 0.000000000000000E+00 z1= 3 -.254955234367613E-06 0.000000000000000E+00 alpha(00000446)=0.000000000000000E+00 beta (00000447)=0.129392779222497E+02 gamma(00000447)=0.129392779222497E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 447 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000447)=0.000000000000000E+00 beta (00000448)=0.131030696732824E+02 gamma(00000448)=0.131030696732824E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 448 z1= 1 -.783882345479815E-03 0.000000000000000E+00 z1= 2 0.502191526141182E-06 0.000000000000000E+00 z1= 3 0.289235564832069E-06 0.000000000000000E+00 alpha(00000448)=0.000000000000000E+00 beta (00000449)=0.125837122065220E+02 gamma(00000449)=0.125837122065220E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 449 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000449)=0.000000000000000E+00 beta (00000450)=0.125755545414751E+02 gamma(00000450)=0.125755545414751E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 450 z1= 1 0.139163532740958E-02 0.000000000000000E+00 z1= 2 -.550102333817621E-06 0.000000000000000E+00 z1= 3 -.319411691470988E-06 0.000000000000000E+00 alpha(00000450)=0.000000000000000E+00 beta (00000451)=0.128761633850663E+02 gamma(00000451)=0.128761633850663E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 451 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000451)=0.000000000000000E+00 beta (00000452)=0.132350465656706E+02 gamma(00000452)=0.132350465656706E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 452 z1= 1 -.203976906339193E-02 0.000000000000000E+00 z1= 2 0.572669045823850E-06 0.000000000000000E+00 z1= 3 0.328262017192191E-06 0.000000000000000E+00 alpha(00000452)=0.000000000000000E+00 beta (00000453)=0.119883763380830E+02 gamma(00000453)=0.119883763380830E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 453 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000453)=0.000000000000000E+00 beta (00000454)=0.142341806970888E+02 gamma(00000454)=0.142341806970888E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 454 z1= 1 0.240780922864578E-02 0.000000000000000E+00 z1= 2 -.532582001449775E-06 0.000000000000000E+00 z1= 3 -.302453096515316E-06 0.000000000000000E+00 alpha(00000454)=0.000000000000000E+00 beta (00000455)=0.124180561177989E+02 gamma(00000455)=0.124180561177989E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 455 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000455)=0.000000000000000E+00 beta (00000456)=0.140335055350961E+02 gamma(00000456)=0.140335055350961E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 456 z1= 1 -.271131668493435E-02 0.000000000000000E+00 z1= 2 0.500808252497549E-06 0.000000000000000E+00 z1= 3 0.255443160063337E-06 0.000000000000000E+00 alpha(00000456)=0.000000000000000E+00 beta (00000457)=0.121785065120065E+02 gamma(00000457)=0.121785065120065E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 457 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000457)=0.000000000000000E+00 beta (00000458)=0.136394392959515E+02 gamma(00000458)=0.136394392959515E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 458 z1= 1 0.290551009694923E-02 0.000000000000000E+00 z1= 2 -.515721771033976E-06 0.000000000000000E+00 z1= 3 -.224665260212210E-06 0.000000000000000E+00 alpha(00000458)=0.000000000000000E+00 beta (00000459)=0.129393761749932E+02 gamma(00000459)=0.129393761749932E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 459 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000459)=0.000000000000000E+00 beta (00000460)=0.138405947591471E+02 gamma(00000460)=0.138405947591471E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 460 z1= 1 -.298991790577588E-02 0.000000000000000E+00 z1= 2 0.503395203610944E-06 0.000000000000000E+00 z1= 3 0.170675832306317E-06 0.000000000000000E+00 alpha(00000460)=0.000000000000000E+00 beta (00000461)=0.131818585156317E+02 gamma(00000461)=0.131818585156317E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 461 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000461)=0.000000000000000E+00 beta (00000462)=0.133061921153023E+02 gamma(00000462)=0.133061921153023E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 462 z1= 1 0.321545244865769E-02 0.000000000000000E+00 z1= 2 -.581318038036377E-06 0.000000000000000E+00 z1= 3 -.166105827574255E-06 0.000000000000000E+00 alpha(00000462)=0.000000000000000E+00 beta (00000463)=0.121087367012333E+02 gamma(00000463)=0.121087367012333E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 463 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000463)=0.000000000000000E+00 beta (00000464)=0.131134380375962E+02 gamma(00000464)=0.131134380375962E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 464 z1= 1 -.329886039334082E-02 0.000000000000000E+00 z1= 2 0.554055190517353E-06 0.000000000000000E+00 z1= 3 0.103946208775010E-06 0.000000000000000E+00 alpha(00000464)=0.000000000000000E+00 beta (00000465)=0.127256316285929E+02 gamma(00000465)=0.127256316285929E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 465 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000465)=0.000000000000000E+00 beta (00000466)=0.139767434712510E+02 gamma(00000466)=0.139767434712510E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 466 z1= 1 0.326388815712446E-02 0.000000000000000E+00 z1= 2 -.606826000572845E-06 0.000000000000000E+00 z1= 3 -.111710378037711E-06 0.000000000000000E+00 alpha(00000466)=0.000000000000000E+00 beta (00000467)=0.126597231415771E+02 gamma(00000467)=0.126597231415771E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 467 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000467)=0.000000000000000E+00 beta (00000468)=0.134318432850137E+02 gamma(00000468)=0.134318432850137E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 468 z1= 1 -.323402302221944E-02 0.000000000000000E+00 z1= 2 0.557417675535205E-06 0.000000000000000E+00 z1= 3 0.427511737931003E-07 0.000000000000000E+00 alpha(00000468)=0.000000000000000E+00 beta (00000469)=0.134136913706433E+02 gamma(00000469)=0.134136913706433E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 469 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000469)=0.000000000000000E+00 beta (00000470)=0.142716410959124E+02 gamma(00000470)=0.142716410959124E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 470 z1= 1 0.311395874109545E-02 0.000000000000000E+00 z1= 2 -.652271332276383E-06 0.000000000000000E+00 z1= 3 -.826515529411473E-07 0.000000000000000E+00 alpha(00000470)=0.000000000000000E+00 beta (00000471)=0.124907955911326E+02 gamma(00000471)=0.124907955911326E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 471 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000471)=0.000000000000000E+00 beta (00000472)=0.135377848987718E+02 gamma(00000472)=0.135377848987718E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 472 z1= 1 -.297234858757380E-02 0.000000000000000E+00 z1= 2 0.582174284459534E-06 0.000000000000000E+00 z1= 3 0.386269276763870E-08 0.000000000000000E+00 alpha(00000472)=0.000000000000000E+00 beta (00000473)=0.125111589671538E+02 gamma(00000473)=0.125111589671538E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 473 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000473)=0.000000000000000E+00 beta (00000474)=0.139412832725579E+02 gamma(00000474)=0.139412832725579E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 474 z1= 1 0.284088384745655E-02 0.000000000000000E+00 z1= 2 -.656129638074501E-06 0.000000000000000E+00 z1= 3 -.582529302128442E-07 0.000000000000000E+00 alpha(00000474)=0.000000000000000E+00 beta (00000475)=0.128943703360242E+02 gamma(00000475)=0.128943703360242E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 475 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000475)=0.000000000000000E+00 beta (00000476)=0.133911208207724E+02 gamma(00000476)=0.133911208207724E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 476 z1= 1 -.297876139258758E-02 0.000000000000000E+00 z1= 2 0.621277307164773E-06 0.000000000000000E+00 z1= 3 0.281656440510002E-07 0.000000000000000E+00 alpha(00000476)=0.000000000000000E+00 beta (00000477)=0.132652776327423E+02 gamma(00000477)=0.132652776327423E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 477 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000477)=0.000000000000000E+00 beta (00000478)=0.146769180230859E+02 gamma(00000478)=0.146769180230859E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 478 z1= 1 0.295169157488322E-02 0.000000000000000E+00 z1= 2 -.687693442545656E-06 0.000000000000000E+00 z1= 3 -.109558753215281E-06 0.000000000000000E+00 alpha(00000478)=0.000000000000000E+00 beta (00000479)=0.124836879532928E+02 gamma(00000479)=0.124836879532928E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 479 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000479)=0.000000000000000E+00 beta (00000480)=0.134187132176873E+02 gamma(00000480)=0.134187132176873E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 480 z1= 1 -.305212737395313E-02 0.000000000000000E+00 z1= 2 0.664584482786001E-06 0.000000000000000E+00 z1= 3 0.118812172073587E-06 0.000000000000000E+00 alpha(00000480)=0.000000000000000E+00 beta (00000481)=0.124907908043920E+02 gamma(00000481)=0.124907908043920E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 481 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000481)=0.000000000000000E+00 beta (00000482)=0.135964996108200E+02 gamma(00000482)=0.135964996108200E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 482 z1= 1 0.303021688289112E-02 0.000000000000000E+00 z1= 2 -.709245912116404E-06 0.000000000000000E+00 z1= 3 -.177832991689997E-06 0.000000000000000E+00 alpha(00000482)=0.000000000000000E+00 beta (00000483)=0.125985994260274E+02 gamma(00000483)=0.125985994260274E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 483 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000483)=0.000000000000000E+00 beta (00000484)=0.138097281373297E+02 gamma(00000484)=0.138097281373297E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 484 z1= 1 -.302485226916403E-02 0.000000000000000E+00 z1= 2 0.718600187694495E-06 0.000000000000000E+00 z1= 3 0.225079741201508E-06 0.000000000000000E+00 alpha(00000484)=0.000000000000000E+00 beta (00000485)=0.129195839155350E+02 gamma(00000485)=0.129195839155350E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 485 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000485)=0.000000000000000E+00 beta (00000486)=0.134558273944377E+02 gamma(00000486)=0.134558273944377E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 486 z1= 1 0.317447231563175E-02 0.000000000000000E+00 z1= 2 -.756377567148747E-06 0.000000000000000E+00 z1= 3 -.284318686747049E-06 0.000000000000000E+00 alpha(00000486)=0.000000000000000E+00 beta (00000487)=0.125101780288900E+02 gamma(00000487)=0.125101780288900E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 487 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000487)=0.000000000000000E+00 beta (00000488)=0.132497285624578E+02 gamma(00000488)=0.132497285624578E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 488 z1= 1 -.327922246424820E-02 0.000000000000000E+00 z1= 2 0.837086958997355E-06 0.000000000000000E+00 z1= 3 0.381326202747521E-06 0.000000000000000E+00 alpha(00000488)=0.000000000000000E+00 beta (00000489)=0.128908676049424E+02 gamma(00000489)=0.128908676049424E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 489 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000489)=0.000000000000000E+00 beta (00000490)=0.138745574644651E+02 gamma(00000490)=0.138745574644651E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 490 z1= 1 0.332457606399162E-02 0.000000000000000E+00 z1= 2 -.799773597823933E-06 0.000000000000000E+00 z1= 3 -.394008116117828E-06 0.000000000000000E+00 alpha(00000490)=0.000000000000000E+00 beta (00000491)=0.132002437470630E+02 gamma(00000491)=0.132002437470630E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 491 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000491)=0.000000000000000E+00 beta (00000492)=0.131370982977820E+02 gamma(00000492)=0.131370982977820E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 492 z1= 1 -.360550052006049E-02 0.000000000000000E+00 z1= 2 0.976738597378325E-06 0.000000000000000E+00 z1= 3 0.547664850812283E-06 0.000000000000000E+00 alpha(00000492)=0.000000000000000E+00 beta (00000493)=0.123498623823176E+02 gamma(00000493)=0.123498623823176E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 493 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000493)=0.000000000000000E+00 beta (00000494)=0.144150789045414E+02 gamma(00000494)=0.144150789045414E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 494 z1= 1 0.332016542569275E-02 0.000000000000000E+00 z1= 2 -.818756975014441E-06 0.000000000000000E+00 z1= 3 -.485911668145889E-06 0.000000000000000E+00 alpha(00000494)=0.000000000000000E+00 beta (00000495)=0.121479048807039E+02 gamma(00000495)=0.121479048807039E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 495 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000495)=0.000000000000000E+00 beta (00000496)=0.141946597069244E+02 gamma(00000496)=0.141946597069244E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 496 z1= 1 -.304435299517151E-02 0.000000000000000E+00 z1= 2 0.922934538023779E-06 0.000000000000000E+00 z1= 3 0.598082770532463E-06 0.000000000000000E+00 alpha(00000496)=0.000000000000000E+00 beta (00000497)=0.126799826624054E+02 gamma(00000497)=0.126799826624054E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 497 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000497)=0.000000000000000E+00 beta (00000498)=0.139013094599489E+02 gamma(00000498)=0.139013094599489E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 498 z1= 1 0.290067046908029E-02 0.000000000000000E+00 z1= 2 -.800955535280260E-06 0.000000000000000E+00 z1= 3 -.547067694908957E-06 0.000000000000000E+00 alpha(00000498)=0.000000000000000E+00 beta (00000499)=0.122460147692821E+02 gamma(00000499)=0.122460147692821E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 499 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000499)=0.000000000000000E+00 beta (00000500)=0.137001471649196E+02 gamma(00000500)=0.137001471649196E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 500 z1= 1 -.275317426283719E-02 0.000000000000000E+00 z1= 2 0.998824329780535E-06 0.000000000000000E+00 z1= 3 0.727795576390325E-06 0.000000000000000E+00 alpha(00000500)=0.000000000000000E+00 beta (00000501)=0.128500794706463E+02 gamma(00000501)=0.128500794706463E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Norm of initial Lanczos vectors= 0.939778361435554 Starting Lanczos loop 2 Lanczos iteration: 1 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal alpha(00000001)=0.000000000000000E+00 beta (00000002)=0.202673035172511E+01 gamma(00000002)=0.202673035172511E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 2 z1= 1 -.840273691035329E-08 0.000000000000000E+00 z1= 2 0.629150320345045E+00 0.000000000000000E+00 z1= 3 -.190054821919312E-07 0.000000000000000E+00 alpha(00000002)=0.000000000000000E+00 beta (00000003)=0.676215550562917E+01 gamma(00000003)=0.676215550562917E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 3 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000003)=0.000000000000000E+00 beta (00000004)=0.144232831078440E+02 gamma(00000004)=0.144232831078440E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 4 z1= 1 0.866216382433213E-08 0.000000000000000E+00 z1= 2 -.235142358423867E+00 0.000000000000000E+00 z1= 3 0.535812169914947E-08 0.000000000000000E+00 alpha(00000004)=0.000000000000000E+00 beta (00000005)=0.123530542974145E+02 gamma(00000005)=0.123530542974145E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 5 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000005)=0.000000000000000E+00 beta (00000006)=0.140729543680908E+02 gamma(00000006)=0.140729543680908E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 6 z1= 1 0.695446186315535E-09 0.000000000000000E+00 z1= 2 0.183518276653757E+00 0.000000000000000E+00 z1= 3 -.968158242161191E-08 0.000000000000000E+00 alpha(00000006)=0.000000000000000E+00 beta (00000007)=0.125639473042696E+02 gamma(00000007)=0.125639473042696E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 7 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000007)=0.000000000000000E+00 beta (00000008)=0.137603538391131E+02 gamma(00000008)=0.137603538391131E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 8 z1= 1 -.656810189830076E-08 0.000000000000000E+00 z1= 2 -.154635987759994E+00 0.000000000000000E+00 z1= 3 0.121485123046397E-07 0.000000000000000E+00 alpha(00000008)=0.000000000000000E+00 beta (00000009)=0.127447855993611E+02 gamma(00000009)=0.127447855993611E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 9 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000009)=0.000000000000000E+00 beta (00000010)=0.137234299667425E+02 gamma(00000010)=0.137234299667425E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 10 z1= 1 0.124907271990826E-07 0.000000000000000E+00 z1= 2 0.135281351432880E+00 0.000000000000000E+00 z1= 3 -.151505301459846E-07 0.000000000000000E+00 alpha(00000010)=0.000000000000000E+00 beta (00000011)=0.128469574181135E+02 gamma(00000011)=0.128469574181135E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 11 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000011)=0.000000000000000E+00 beta (00000012)=0.137259807375843E+02 gamma(00000012)=0.137259807375843E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 12 z1= 1 -.191357745378540E-07 0.000000000000000E+00 z1= 2 -.120561005285351E+00 0.000000000000000E+00 z1= 3 0.187245205464891E-07 0.000000000000000E+00 alpha(00000012)=0.000000000000000E+00 beta (00000013)=0.128257475368255E+02 gamma(00000013)=0.128257475368255E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 13 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000013)=0.000000000000000E+00 beta (00000014)=0.137037769080156E+02 gamma(00000014)=0.137037769080156E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 14 z1= 1 0.262307310039400E-07 0.000000000000000E+00 z1= 2 0.108228080531269E+00 0.000000000000000E+00 z1= 3 -.226022368692274E-07 0.000000000000000E+00 alpha(00000014)=0.000000000000000E+00 beta (00000015)=0.128910476616630E+02 gamma(00000015)=0.128910476616630E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 15 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000015)=0.000000000000000E+00 beta (00000016)=0.137489009924921E+02 gamma(00000016)=0.137489009924921E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 16 z1= 1 -.325463600731393E-07 0.000000000000000E+00 z1= 2 -.978708379590942E-01 0.000000000000000E+00 z1= 3 0.258365247891770E-07 0.000000000000000E+00 alpha(00000016)=0.000000000000000E+00 beta (00000017)=0.128678038863169E+02 gamma(00000017)=0.128678038863169E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 17 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000017)=0.000000000000000E+00 beta (00000018)=0.135655635443460E+02 gamma(00000018)=0.135655635443460E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 18 z1= 1 0.382500756988119E-07 0.000000000000000E+00 z1= 2 0.898836940840155E-01 0.000000000000000E+00 z1= 3 -.287616161332317E-07 0.000000000000000E+00 alpha(00000018)=0.000000000000000E+00 beta (00000019)=0.127873625632696E+02 gamma(00000019)=0.127873625632696E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 19 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000019)=0.000000000000000E+00 beta (00000020)=0.135613686132658E+02 gamma(00000020)=0.135613686132658E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 20 z1= 1 -.427589679696458E-07 0.000000000000000E+00 z1= 2 -.823803304976590E-01 0.000000000000000E+00 z1= 3 0.309374355669280E-07 0.000000000000000E+00 alpha(00000020)=0.000000000000000E+00 beta (00000021)=0.128376469781321E+02 gamma(00000021)=0.128376469781321E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 21 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000021)=0.000000000000000E+00 beta (00000022)=0.136499887338587E+02 gamma(00000022)=0.136499887338587E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 22 z1= 1 0.460254893945231E-07 0.000000000000000E+00 z1= 2 0.755596215029548E-01 0.000000000000000E+00 z1= 3 -.324247115123400E-07 0.000000000000000E+00 alpha(00000022)=0.000000000000000E+00 beta (00000023)=0.129827388314093E+02 gamma(00000023)=0.129827388314093E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 23 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000023)=0.000000000000000E+00 beta (00000024)=0.134495769482310E+02 gamma(00000024)=0.134495769482310E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 24 z1= 1 -.501905103571926E-07 0.000000000000000E+00 z1= 2 -.713477524712115E-01 0.000000000000000E+00 z1= 3 0.347058372976742E-07 0.000000000000000E+00 alpha(00000024)=0.000000000000000E+00 beta (00000025)=0.126681704246666E+02 gamma(00000025)=0.126681704246666E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 25 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000025)=0.000000000000000E+00 beta (00000026)=0.137615919272572E+02 gamma(00000026)=0.137615919272572E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 26 z1= 1 0.513204524363320E-07 0.000000000000000E+00 z1= 2 0.644237924058881E-01 0.000000000000000E+00 z1= 3 -.349099330774745E-07 0.000000000000000E+00 alpha(00000026)=0.000000000000000E+00 beta (00000027)=0.130623618306095E+02 gamma(00000027)=0.130623618306095E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 27 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000027)=0.000000000000000E+00 beta (00000028)=0.135141735696965E+02 gamma(00000028)=0.135141735696965E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 28 z1= 1 -.546432508685690E-07 0.000000000000000E+00 z1= 2 -.612013168367397E-01 0.000000000000000E+00 z1= 3 0.365668951298761E-07 0.000000000000000E+00 alpha(00000028)=0.000000000000000E+00 beta (00000029)=0.130061862477232E+02 gamma(00000029)=0.130061862477232E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 29 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000029)=0.000000000000000E+00 beta (00000030)=0.137121950996972E+02 gamma(00000030)=0.137121950996972E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 30 z1= 1 0.567659391367825E-07 0.000000000000000E+00 z1= 2 0.571692441436834E-01 0.000000000000000E+00 z1= 3 -.372846663906521E-07 0.000000000000000E+00 alpha(00000030)=0.000000000000000E+00 beta (00000031)=0.128582571502361E+02 gamma(00000031)=0.128582571502361E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 31 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000031)=0.000000000000000E+00 beta (00000032)=0.136045240096737E+02 gamma(00000032)=0.136045240096737E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 32 z1= 1 -.585669585675963E-07 0.000000000000000E+00 z1= 2 -.532957273754172E-01 0.000000000000000E+00 z1= 3 0.375574013651223E-07 0.000000000000000E+00 alpha(00000032)=0.000000000000000E+00 beta (00000033)=0.128128167587433E+02 gamma(00000033)=0.128128167587433E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 33 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000033)=0.000000000000000E+00 beta (00000034)=0.137299922797625E+02 gamma(00000034)=0.137299922797625E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 34 z1= 1 0.597085080128457E-07 0.000000000000000E+00 z1= 2 0.490958632847919E-01 0.000000000000000E+00 z1= 3 -.371057101438040E-07 0.000000000000000E+00 alpha(00000034)=0.000000000000000E+00 beta (00000035)=0.126998649744284E+02 gamma(00000035)=0.126998649744284E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 35 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000035)=0.000000000000000E+00 beta (00000036)=0.133734219360923E+02 gamma(00000036)=0.133734219360923E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 36 z1= 1 -.620257766033999E-07 0.000000000000000E+00 z1= 2 -.459820578428988E-01 0.000000000000000E+00 z1= 3 0.371417713323444E-07 0.000000000000000E+00 alpha(00000036)=0.000000000000000E+00 beta (00000037)=0.129695325562462E+02 gamma(00000037)=0.129695325562462E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 37 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000037)=0.000000000000000E+00 beta (00000038)=0.134594494755700E+02 gamma(00000038)=0.134594494755700E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 38 z1= 1 0.660801140646428E-07 0.000000000000000E+00 z1= 2 0.437562476610413E-01 0.000000000000000E+00 z1= 3 -.382047938914283E-07 0.000000000000000E+00 alpha(00000038)=0.000000000000000E+00 beta (00000039)=0.129374599071341E+02 gamma(00000039)=0.129374599071341E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 39 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000039)=0.000000000000000E+00 beta (00000040)=0.134403532990276E+02 gamma(00000040)=0.134403532990276E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 40 z1= 1 -.704284880432421E-07 0.000000000000000E+00 z1= 2 -.416197230788300E-01 0.000000000000000E+00 z1= 3 0.393929319650321E-07 0.000000000000000E+00 alpha(00000040)=0.000000000000000E+00 beta (00000041)=0.128080771590084E+02 gamma(00000041)=0.128080771590084E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 41 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000041)=0.000000000000000E+00 beta (00000042)=0.136926832177320E+02 gamma(00000042)=0.136926832177320E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 42 z1= 1 0.719597088964796E-07 0.000000000000000E+00 z1= 2 0.384617585944355E-01 0.000000000000000E+00 z1= 3 -.389841483875147E-07 0.000000000000000E+00 alpha(00000042)=0.000000000000000E+00 beta (00000043)=0.127889269599290E+02 gamma(00000043)=0.127889269599290E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 43 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000043)=0.000000000000000E+00 beta (00000044)=0.136041849901176E+02 gamma(00000044)=0.136041849901176E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 44 z1= 1 -.749578923115585E-07 0.000000000000000E+00 z1= 2 -.357055006800557E-01 0.000000000000000E+00 z1= 3 0.394783647474084E-07 0.000000000000000E+00 alpha(00000044)=0.000000000000000E+00 beta (00000045)=0.125338689509538E+02 gamma(00000045)=0.125338689509538E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 45 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000045)=0.000000000000000E+00 beta (00000046)=0.133781081666765E+02 gamma(00000046)=0.133781081666765E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 46 z1= 1 0.790621177606393E-07 0.000000000000000E+00 z1= 2 0.329952344302760E-01 0.000000000000000E+00 z1= 3 -.409579179947968E-07 0.000000000000000E+00 alpha(00000046)=0.000000000000000E+00 beta (00000047)=0.124795000260810E+02 gamma(00000047)=0.124795000260810E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 47 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000047)=0.000000000000000E+00 beta (00000048)=0.135947238249215E+02 gamma(00000048)=0.135947238249215E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 48 z1= 1 -.820529297692815E-07 0.000000000000000E+00 z1= 2 -.297955140600106E-01 0.000000000000000E+00 z1= 3 0.424358834539076E-07 0.000000000000000E+00 alpha(00000048)=0.000000000000000E+00 beta (00000049)=0.131024561750331E+02 gamma(00000049)=0.131024561750331E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 49 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000049)=0.000000000000000E+00 beta (00000050)=0.138619193132726E+02 gamma(00000050)=0.138619193132726E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 50 z1= 1 0.876695003190764E-07 0.000000000000000E+00 z1= 2 0.277672221628477E-01 0.000000000000000E+00 z1= 3 -.456564251130002E-07 0.000000000000000E+00 alpha(00000050)=0.000000000000000E+00 beta (00000051)=0.127745801736840E+02 gamma(00000051)=0.127745801736840E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 51 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000051)=0.000000000000000E+00 beta (00000052)=0.133888718845827E+02 gamma(00000052)=0.133888718845827E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 52 z1= 1 -.942457964179036E-07 0.000000000000000E+00 z1= 2 -.260939693067293E-01 0.000000000000000E+00 z1= 3 0.495963113390243E-07 0.000000000000000E+00 alpha(00000052)=0.000000000000000E+00 beta (00000053)=0.126291420494436E+02 gamma(00000053)=0.126291420494436E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 53 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000053)=0.000000000000000E+00 beta (00000054)=0.132483599904286E+02 gamma(00000054)=0.132483599904286E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 54 z1= 1 0.100962838309356E-06 0.000000000000000E+00 z1= 2 0.244847369480104E-01 0.000000000000000E+00 z1= 3 -.538725828173837E-07 0.000000000000000E+00 alpha(00000054)=0.000000000000000E+00 beta (00000055)=0.133544716897312E+02 gamma(00000055)=0.133544716897312E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 55 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000055)=0.000000000000000E+00 beta (00000056)=0.135533927720147E+02 gamma(00000056)=0.135533927720147E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 56 z1= 1 -.110368489692966E-06 0.000000000000000E+00 z1= 2 -.238031955269809E-01 0.000000000000000E+00 z1= 3 0.598212772323723E-07 0.000000000000000E+00 alpha(00000056)=0.000000000000000E+00 beta (00000057)=0.131799144421085E+02 gamma(00000057)=0.131799144421085E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 57 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000057)=0.000000000000000E+00 beta (00000058)=0.132398849224801E+02 gamma(00000058)=0.132398849224801E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 58 z1= 1 0.120922451086157E-06 0.000000000000000E+00 z1= 2 0.233925140384075E-01 0.000000000000000E+00 z1= 3 -.666465906851372E-07 0.000000000000000E+00 alpha(00000058)=0.000000000000000E+00 beta (00000059)=0.127465019729514E+02 gamma(00000059)=0.127465019729514E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 59 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000059)=0.000000000000000E+00 beta (00000060)=0.136005143659272E+02 gamma(00000060)=0.136005143659272E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 60 z1= 1 -.124772218232719E-06 0.000000000000000E+00 z1= 2 -.216461183029716E-01 0.000000000000000E+00 z1= 3 0.698561615004758E-07 0.000000000000000E+00 alpha(00000060)=0.000000000000000E+00 beta (00000061)=0.132678830175691E+02 gamma(00000061)=0.132678830175691E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 61 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000061)=0.000000000000000E+00 beta (00000062)=0.139178904944427E+02 gamma(00000062)=0.139178904944427E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 62 z1= 1 0.130875783597648E-06 0.000000000000000E+00 z1= 2 0.203694987325270E-01 0.000000000000000E+00 z1= 3 -.741674612362837E-07 0.000000000000000E+00 alpha(00000062)=0.000000000000000E+00 beta (00000063)=0.131207438016046E+02 gamma(00000063)=0.131207438016046E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 63 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000063)=0.000000000000000E+00 beta (00000064)=0.135797841589467E+02 gamma(00000064)=0.135797841589467E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 64 z1= 1 -.139592097007403E-06 0.000000000000000E+00 z1= 2 -.193892722332408E-01 0.000000000000000E+00 z1= 3 0.799063876298921E-07 0.000000000000000E+00 alpha(00000064)=0.000000000000000E+00 beta (00000065)=0.125572721540728E+02 gamma(00000065)=0.125572721540728E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 65 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000065)=0.000000000000000E+00 beta (00000066)=0.134171299655795E+02 gamma(00000066)=0.134171299655795E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 66 z1= 1 0.144666121797143E-06 0.000000000000000E+00 z1= 2 0.178765986494537E-01 0.000000000000000E+00 z1= 3 -.834474735923111E-07 0.000000000000000E+00 alpha(00000066)=0.000000000000000E+00 beta (00000067)=0.132069991467829E+02 gamma(00000067)=0.132069991467829E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 67 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000067)=0.000000000000000E+00 beta (00000068)=0.138669399286134E+02 gamma(00000068)=0.138669399286134E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 68 z1= 1 -.150599569119156E-06 0.000000000000000E+00 z1= 2 -.168651823851768E-01 0.000000000000000E+00 z1= 3 0.870970967049313E-07 0.000000000000000E+00 alpha(00000068)=0.000000000000000E+00 beta (00000069)=0.130391539918933E+02 gamma(00000069)=0.130391539918933E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 69 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000069)=0.000000000000000E+00 beta (00000070)=0.133420148868221E+02 gamma(00000070)=0.133420148868221E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 70 z1= 1 0.161336244566303E-06 0.000000000000000E+00 z1= 2 0.163359174257748E-01 0.000000000000000E+00 z1= 3 -.933463799146603E-07 0.000000000000000E+00 alpha(00000070)=0.000000000000000E+00 beta (00000071)=0.127754750180337E+02 gamma(00000071)=0.127754750180337E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 71 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000071)=0.000000000000000E+00 beta (00000072)=0.139992905040343E+02 gamma(00000072)=0.139992905040343E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 72 z1= 1 -.161941920252991E-06 0.000000000000000E+00 z1= 2 -.148089986589053E-01 0.000000000000000E+00 z1= 3 0.935431941982809E-07 0.000000000000000E+00 alpha(00000072)=0.000000000000000E+00 beta (00000073)=0.128546529501330E+02 gamma(00000073)=0.128546529501330E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 73 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000073)=0.000000000000000E+00 beta (00000074)=0.132957977825601E+02 gamma(00000074)=0.132957977825601E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 74 z1= 1 0.173134653226950E-06 0.000000000000000E+00 z1= 2 0.142243374139229E-01 0.000000000000000E+00 z1= 3 -.994106071899729E-07 0.000000000000000E+00 alpha(00000074)=0.000000000000000E+00 beta (00000075)=0.122777254144820E+02 gamma(00000075)=0.122777254144820E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 75 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000075)=0.000000000000000E+00 beta (00000076)=0.134301661369493E+02 gamma(00000076)=0.134301661369493E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 76 z1= 1 -.175036880638128E-06 0.000000000000000E+00 z1= 2 -.129315655247857E-01 0.000000000000000E+00 z1= 3 0.994873678204040E-07 0.000000000000000E+00 alpha(00000076)=0.000000000000000E+00 beta (00000077)=0.128560630795165E+02 gamma(00000077)=0.128560630795165E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 77 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000077)=0.000000000000000E+00 beta (00000078)=0.139567547312413E+02 gamma(00000078)=0.139567547312413E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 78 z1= 1 0.178580586875435E-06 0.000000000000000E+00 z1= 2 0.119216739961861E-01 0.000000000000000E+00 z1= 3 -.100562120085670E-06 0.000000000000000E+00 alpha(00000078)=0.000000000000000E+00 beta (00000079)=0.127756124743608E+02 gamma(00000079)=0.127756124743608E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 79 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000079)=0.000000000000000E+00 beta (00000080)=0.134013297715585E+02 gamma(00000080)=0.134013297715585E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 80 z1= 1 -.190346069753322E-06 0.000000000000000E+00 z1= 2 -.114307973104521E-01 0.000000000000000E+00 z1= 3 0.106117652250181E-06 0.000000000000000E+00 alpha(00000080)=0.000000000000000E+00 beta (00000081)=0.126747054586590E+02 gamma(00000081)=0.126747054586590E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 81 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000081)=0.000000000000000E+00 beta (00000082)=0.140252582563135E+02 gamma(00000082)=0.140252582563135E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 82 z1= 1 0.191520535913932E-06 0.000000000000000E+00 z1= 2 0.104015711651783E-01 0.000000000000000E+00 z1= 3 -.105398481967610E-06 0.000000000000000E+00 alpha(00000082)=0.000000000000000E+00 beta (00000083)=0.128491964034501E+02 gamma(00000083)=0.128491964034501E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 83 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000083)=0.000000000000000E+00 beta (00000084)=0.131673842549759E+02 gamma(00000084)=0.131673842549759E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 84 z1= 1 -.208055649542939E-06 0.000000000000000E+00 z1= 2 -.102532541815098E-01 0.000000000000000E+00 z1= 3 0.112613442792143E-06 0.000000000000000E+00 alpha(00000084)=0.000000000000000E+00 beta (00000085)=0.128600971965991E+02 gamma(00000085)=0.128600971965991E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 85 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000085)=0.000000000000000E+00 beta (00000086)=0.142145542203513E+02 gamma(00000086)=0.142145542203513E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 86 z1= 1 0.207370308520291E-06 0.000000000000000E+00 z1= 2 0.923026582528372E-02 0.000000000000000E+00 z1= 3 -.110515074188918E-06 0.000000000000000E+00 alpha(00000086)=0.000000000000000E+00 beta (00000087)=0.126364328806557E+02 gamma(00000087)=0.126364328806557E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 87 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000087)=0.000000000000000E+00 beta (00000088)=0.133498527796537E+02 gamma(00000088)=0.133498527796537E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 88 z1= 1 -.217969054330108E-06 0.000000000000000E+00 z1= 2 -.856243483333900E-02 0.000000000000000E+00 z1= 3 0.114174327032904E-06 0.000000000000000E+00 alpha(00000088)=0.000000000000000E+00 beta (00000089)=0.129282617763503E+02 gamma(00000089)=0.129282617763503E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 89 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000089)=0.000000000000000E+00 beta (00000090)=0.137915215545991E+02 gamma(00000090)=0.137915215545991E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 90 z1= 1 0.225567742972825E-06 0.000000000000000E+00 z1= 2 0.780725722297027E-02 0.000000000000000E+00 z1= 3 -.116445153134932E-06 0.000000000000000E+00 alpha(00000090)=0.000000000000000E+00 beta (00000091)=0.125622383813329E+02 gamma(00000091)=0.125622383813329E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 91 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000091)=0.000000000000000E+00 beta (00000092)=0.129073366150311E+02 gamma(00000092)=0.129073366150311E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 92 z1= 1 -.244457018100386E-06 0.000000000000000E+00 z1= 2 -.736948401439334E-02 0.000000000000000E+00 z1= 3 0.124748797534179E-06 0.000000000000000E+00 alpha(00000092)=0.000000000000000E+00 beta (00000093)=0.134136126060794E+02 gamma(00000093)=0.134136126060794E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 93 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000093)=0.000000000000000E+00 beta (00000094)=0.132877190571874E+02 gamma(00000094)=0.132877190571874E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 94 z1= 1 0.268805554010532E-06 0.000000000000000E+00 z1= 2 0.726621728533319E-02 0.000000000000000E+00 z1= 3 -.136115518967195E-06 0.000000000000000E+00 alpha(00000094)=0.000000000000000E+00 beta (00000095)=0.124147974242515E+02 gamma(00000095)=0.124147974242515E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 95 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000095)=0.000000000000000E+00 beta (00000096)=0.130372610992631E+02 gamma(00000096)=0.130372610992631E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 96 z1= 1 -.278690040220100E-06 0.000000000000000E+00 z1= 2 -.676488744851333E-02 0.000000000000000E+00 z1= 3 0.140359749023955E-06 0.000000000000000E+00 alpha(00000096)=0.000000000000000E+00 beta (00000097)=0.127828860361187E+02 gamma(00000097)=0.127828860361187E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 97 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000097)=0.000000000000000E+00 beta (00000098)=0.128636383094032E+02 gamma(00000098)=0.128636383094032E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 98 z1= 1 0.299594808612132E-06 0.000000000000000E+00 z1= 2 0.652989929269417E-02 0.000000000000000E+00 z1= 3 -.150697245044772E-06 0.000000000000000E+00 alpha(00000098)=0.000000000000000E+00 beta (00000099)=0.120951339250559E+02 gamma(00000099)=0.120951339250559E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 99 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000099)=0.000000000000000E+00 beta (00000100)=0.135705233005008E+02 gamma(00000100)=0.135705233005008E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 100 z1= 1 -.287053187136409E-06 0.000000000000000E+00 z1= 2 -.570304139994408E-02 0.000000000000000E+00 z1= 3 0.144070992131164E-06 0.000000000000000E+00 alpha(00000100)=0.000000000000000E+00 beta (00000101)=0.130003486688401E+02 gamma(00000101)=0.130003486688401E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 101 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000101)=0.000000000000000E+00 beta (00000102)=0.130515110308961E+02 gamma(00000102)=0.130515110308961E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 102 z1= 1 0.304461813117277E-06 0.000000000000000E+00 z1= 2 0.570639378087550E-02 0.000000000000000E+00 z1= 3 -.152197408151764E-06 0.000000000000000E+00 alpha(00000102)=0.000000000000000E+00 beta (00000103)=0.136735209072848E+02 gamma(00000103)=0.136735209072848E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 103 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000103)=0.000000000000000E+00 beta (00000104)=0.134250041883660E+02 gamma(00000104)=0.134250041883660E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 104 z1= 1 -.325013365197859E-06 0.000000000000000E+00 z1= 2 -.601807438901181E-02 0.000000000000000E+00 z1= 3 0.161771930384740E-06 0.000000000000000E+00 alpha(00000104)=0.000000000000000E+00 beta (00000105)=0.130029861731668E+02 gamma(00000105)=0.130029861731668E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 105 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000105)=0.000000000000000E+00 beta (00000106)=0.141250408167301E+02 gamma(00000106)=0.141250408167301E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 106 z1= 1 0.313437665013655E-06 0.000000000000000E+00 z1= 2 0.578945520765328E-02 0.000000000000000E+00 z1= 3 -.155689636327280E-06 0.000000000000000E+00 alpha(00000106)=0.000000000000000E+00 beta (00000107)=0.132679806060370E+02 gamma(00000107)=0.132679806060370E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 107 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000107)=0.000000000000000E+00 beta (00000108)=0.133905808706558E+02 gamma(00000108)=0.133905808706558E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 108 z1= 1 -.325997339848533E-06 0.000000000000000E+00 z1= 2 -.598204294043105E-02 0.000000000000000E+00 z1= 3 0.161779732101627E-06 0.000000000000000E+00 alpha(00000108)=0.000000000000000E+00 beta (00000109)=0.136743368760626E+02 gamma(00000109)=0.136743368760626E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 109 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000109)=0.000000000000000E+00 beta (00000110)=0.125334588852179E+02 gamma(00000110)=0.125334588852179E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 110 z1= 1 0.371310464572332E-06 0.000000000000000E+00 z1= 2 0.670168960847151E-02 0.000000000000000E+00 z1= 3 -.184278523915855E-06 0.000000000000000E+00 alpha(00000110)=0.000000000000000E+00 beta (00000111)=0.130342253840004E+02 gamma(00000111)=0.130342253840004E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 111 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000111)=0.000000000000000E+00 beta (00000112)=0.137473300485889E+02 gamma(00000112)=0.137473300485889E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 112 z1= 1 -.364012224285696E-06 0.000000000000000E+00 z1= 2 -.647047046159797E-02 0.000000000000000E+00 z1= 3 0.180630494620775E-06 0.000000000000000E+00 alpha(00000112)=0.000000000000000E+00 beta (00000113)=0.127037937344561E+02 gamma(00000113)=0.127037937344561E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 113 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000113)=0.000000000000000E+00 beta (00000114)=0.137811253184533E+02 gamma(00000114)=0.137811253184533E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 114 z1= 1 0.346291328353829E-06 0.000000000000000E+00 z1= 2 0.611786202027374E-02 0.000000000000000E+00 z1= 3 -.171663317010025E-06 0.000000000000000E+00 alpha(00000114)=0.000000000000000E+00 beta (00000115)=0.119877053405160E+02 gamma(00000115)=0.119877053405160E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 115 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000115)=0.000000000000000E+00 beta (00000116)=0.136754779813820E+02 gamma(00000116)=0.136754779813820E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 116 z1= 1 -.316122236872088E-06 0.000000000000000E+00 z1= 2 -.559990242935679E-02 0.000000000000000E+00 z1= 3 0.157040731894696E-06 0.000000000000000E+00 alpha(00000116)=0.000000000000000E+00 beta (00000117)=0.124468366954270E+02 gamma(00000117)=0.124468366954270E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 117 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000117)=0.000000000000000E+00 beta (00000118)=0.134802369021800E+02 gamma(00000118)=0.134802369021800E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 118 z1= 1 0.305918234750312E-06 0.000000000000000E+00 z1= 2 0.536285258494942E-02 0.000000000000000E+00 z1= 3 -.152667960182182E-06 0.000000000000000E+00 alpha(00000118)=0.000000000000000E+00 beta (00000119)=0.129047937427225E+02 gamma(00000119)=0.129047937427225E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 119 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000119)=0.000000000000000E+00 beta (00000120)=0.134429819989533E+02 gamma(00000120)=0.134429819989533E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 120 z1= 1 -.306932697311142E-06 0.000000000000000E+00 z1= 2 -.521283594289207E-02 0.000000000000000E+00 z1= 3 0.153778630327447E-06 0.000000000000000E+00 alpha(00000120)=0.000000000000000E+00 beta (00000121)=0.128150211935115E+02 gamma(00000121)=0.128150211935115E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 121 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000121)=0.000000000000000E+00 beta (00000122)=0.134033620304428E+02 gamma(00000122)=0.134033620304428E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 122 z1= 1 0.305963111940817E-06 0.000000000000000E+00 z1= 2 0.497735414738119E-02 0.000000000000000E+00 z1= 3 -.153681719738301E-06 0.000000000000000E+00 alpha(00000122)=0.000000000000000E+00 beta (00000123)=0.127879383484694E+02 gamma(00000123)=0.127879383484694E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 123 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000123)=0.000000000000000E+00 beta (00000124)=0.135159110171587E+02 gamma(00000124)=0.135159110171587E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 124 z1= 1 -.301479900340247E-06 0.000000000000000E+00 z1= 2 -.467126638628135E-02 0.000000000000000E+00 z1= 3 0.151496813049351E-06 0.000000000000000E+00 alpha(00000124)=0.000000000000000E+00 beta (00000125)=0.129566879566429E+02 gamma(00000125)=0.129566879566429E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 125 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000125)=0.000000000000000E+00 beta (00000126)=0.137778506590579E+02 gamma(00000126)=0.137778506590579E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 126 z1= 1 0.295313483876861E-06 0.000000000000000E+00 z1= 2 0.442556717814533E-02 0.000000000000000E+00 z1= 3 -.148260189771583E-06 0.000000000000000E+00 alpha(00000126)=0.000000000000000E+00 beta (00000127)=0.128495341519329E+02 gamma(00000127)=0.128495341519329E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 127 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000127)=0.000000000000000E+00 beta (00000128)=0.138112912526109E+02 gamma(00000128)=0.138112912526109E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 128 z1= 1 -.287089238569082E-06 0.000000000000000E+00 z1= 2 -.421853231633459E-02 0.000000000000000E+00 z1= 3 0.143704794236185E-06 0.000000000000000E+00 alpha(00000128)=0.000000000000000E+00 beta (00000129)=0.132562793213821E+02 gamma(00000129)=0.132562793213821E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 129 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000129)=0.000000000000000E+00 beta (00000130)=0.135026272776180E+02 gamma(00000130)=0.135026272776180E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 130 z1= 1 0.294403311208290E-06 0.000000000000000E+00 z1= 2 0.420672159090257E-02 0.000000000000000E+00 z1= 3 -.146584273674494E-06 0.000000000000000E+00 alpha(00000130)=0.000000000000000E+00 beta (00000131)=0.125003631872477E+02 gamma(00000131)=0.125003631872477E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 131 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000131)=0.000000000000000E+00 beta (00000132)=0.135182311953985E+02 gamma(00000132)=0.135182311953985E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 132 z1= 1 -.285982276288996E-06 0.000000000000000E+00 z1= 2 -.390074287972312E-02 0.000000000000000E+00 z1= 3 0.141449648997775E-06 0.000000000000000E+00 alpha(00000132)=0.000000000000000E+00 beta (00000133)=0.124859170199466E+02 gamma(00000133)=0.124859170199466E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 133 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000133)=0.000000000000000E+00 beta (00000134)=0.134673573981180E+02 gamma(00000134)=0.134673573981180E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 134 z1= 1 0.279010459887895E-06 0.000000000000000E+00 z1= 2 0.355805581569289E-02 0.000000000000000E+00 z1= 3 -.136865471137601E-06 0.000000000000000E+00 alpha(00000134)=0.000000000000000E+00 beta (00000135)=0.126728961964015E+02 gamma(00000135)=0.126728961964015E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 135 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000135)=0.000000000000000E+00 beta (00000136)=0.137296574364103E+02 gamma(00000136)=0.137296574364103E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 136 z1= 1 -.270832781403864E-06 0.000000000000000E+00 z1= 2 -.318709051853305E-02 0.000000000000000E+00 z1= 3 0.131662824540211E-06 0.000000000000000E+00 alpha(00000136)=0.000000000000000E+00 beta (00000137)=0.127646977105649E+02 gamma(00000137)=0.127646977105649E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 137 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000137)=0.000000000000000E+00 beta (00000138)=0.131132665446428E+02 gamma(00000138)=0.131132665446428E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 138 z1= 1 0.277843405835539E-06 0.000000000000000E+00 z1= 2 0.304724859022271E-02 0.000000000000000E+00 z1= 3 -.133677105045027E-06 0.000000000000000E+00 alpha(00000138)=0.000000000000000E+00 beta (00000139)=0.123813057184468E+02 gamma(00000139)=0.123813057184468E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 139 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000139)=0.000000000000000E+00 beta (00000140)=0.137849109526620E+02 gamma(00000140)=0.137849109526620E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 140 z1= 1 -.262582066815325E-06 0.000000000000000E+00 z1= 2 -.281293864885824E-02 0.000000000000000E+00 z1= 3 0.124915386381713E-06 0.000000000000000E+00 alpha(00000140)=0.000000000000000E+00 beta (00000141)=0.131108881975291E+02 gamma(00000141)=0.131108881975291E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 141 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000141)=0.000000000000000E+00 beta (00000142)=0.134910859734596E+02 gamma(00000142)=0.134910859734596E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 142 z1= 1 0.268275323851708E-06 0.000000000000000E+00 z1= 2 0.289753083199004E-02 0.000000000000000E+00 z1= 3 -.126475563210588E-06 0.000000000000000E+00 alpha(00000142)=0.000000000000000E+00 beta (00000143)=0.125627954455482E+02 gamma(00000143)=0.125627954455482E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 143 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000143)=0.000000000000000E+00 beta (00000144)=0.134860355849045E+02 gamma(00000144)=0.134860355849045E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 144 z1= 1 -.263233568273142E-06 0.000000000000000E+00 z1= 2 -.296571392759384E-02 0.000000000000000E+00 z1= 3 0.123167928364450E-06 0.000000000000000E+00 alpha(00000144)=0.000000000000000E+00 beta (00000145)=0.130284068789886E+02 gamma(00000145)=0.130284068789886E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 145 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000145)=0.000000000000000E+00 beta (00000146)=0.138278888287373E+02 gamma(00000146)=0.138278888287373E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 146 z1= 1 0.260985428354558E-06 0.000000000000000E+00 z1= 2 0.306722167752588E-02 0.000000000000000E+00 z1= 3 -.121507553780642E-06 0.000000000000000E+00 alpha(00000146)=0.000000000000000E+00 beta (00000147)=0.132057091425060E+02 gamma(00000147)=0.132057091425060E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 147 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000147)=0.000000000000000E+00 beta (00000148)=0.138745638560246E+02 gamma(00000148)=0.138745638560246E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 148 z1= 1 -.261929438685185E-06 0.000000000000000E+00 z1= 2 -.311356926066923E-02 0.000000000000000E+00 z1= 3 0.121965013388271E-06 0.000000000000000E+00 alpha(00000148)=0.000000000000000E+00 beta (00000149)=0.129264566914742E+02 gamma(00000149)=0.129264566914742E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 149 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000149)=0.000000000000000E+00 beta (00000150)=0.133833975524317E+02 gamma(00000150)=0.133833975524317E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 150 z1= 1 0.267452292338974E-06 0.000000000000000E+00 z1= 2 0.318888128209377E-02 0.000000000000000E+00 z1= 3 -.125159766349581E-06 0.000000000000000E+00 alpha(00000150)=0.000000000000000E+00 beta (00000151)=0.126485205292684E+02 gamma(00000151)=0.126485205292684E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 151 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000151)=0.000000000000000E+00 beta (00000152)=0.139238358937455E+02 gamma(00000152)=0.139238358937455E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 152 z1= 1 -.255855789665915E-06 0.000000000000000E+00 z1= 2 -.298279260802518E-02 0.000000000000000E+00 z1= 3 0.120532983027876E-06 0.000000000000000E+00 alpha(00000152)=0.000000000000000E+00 beta (00000153)=0.128200648661516E+02 gamma(00000153)=0.128200648661516E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 153 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000153)=0.000000000000000E+00 beta (00000154)=0.141815914235734E+02 gamma(00000154)=0.141815914235734E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 154 z1= 1 0.243534531508063E-06 0.000000000000000E+00 z1= 2 0.274356016992220E-02 0.000000000000000E+00 z1= 3 -.115747001155859E-06 0.000000000000000E+00 alpha(00000154)=0.000000000000000E+00 beta (00000155)=0.126169666738261E+02 gamma(00000155)=0.126169666738261E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 155 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000155)=0.000000000000000E+00 beta (00000156)=0.133080272869840E+02 gamma(00000156)=0.133080272869840E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 156 z1= 1 -.244033074222987E-06 0.000000000000000E+00 z1= 2 -.264064991632526E-02 0.000000000000000E+00 z1= 3 0.117220683176213E-06 0.000000000000000E+00 alpha(00000156)=0.000000000000000E+00 beta (00000157)=0.126397368702685E+02 gamma(00000157)=0.126397368702685E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 157 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000157)=0.000000000000000E+00 beta (00000158)=0.138195489178719E+02 gamma(00000158)=0.138195489178719E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 158 z1= 1 0.235826453542226E-06 0.000000000000000E+00 z1= 2 0.239264405901264E-02 0.000000000000000E+00 z1= 3 -.114516596106231E-06 0.000000000000000E+00 alpha(00000158)=0.000000000000000E+00 beta (00000159)=0.131172926958490E+02 gamma(00000159)=0.131172926958490E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 159 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000159)=0.000000000000000E+00 beta (00000160)=0.138220960064286E+02 gamma(00000160)=0.138220960064286E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 160 z1= 1 -.237322477587756E-06 0.000000000000000E+00 z1= 2 -.222855803159199E-02 0.000000000000000E+00 z1= 3 0.116530175615307E-06 0.000000000000000E+00 alpha(00000160)=0.000000000000000E+00 beta (00000161)=0.129639311096828E+02 gamma(00000161)=0.129639311096828E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 161 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000161)=0.000000000000000E+00 beta (00000162)=0.133309362251668E+02 gamma(00000162)=0.133309362251668E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 162 z1= 1 0.244525535112328E-06 0.000000000000000E+00 z1= 2 0.206312112907694E-02 0.000000000000000E+00 z1= 3 -.121316843504186E-06 0.000000000000000E+00 alpha(00000162)=0.000000000000000E+00 beta (00000163)=0.125189995376978E+02 gamma(00000163)=0.125189995376978E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 163 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000163)=0.000000000000000E+00 beta (00000164)=0.134918301507821E+02 gamma(00000164)=0.134918301507821E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 164 z1= 1 -.239158483821087E-06 0.000000000000000E+00 z1= 2 -.172222356900368E-02 0.000000000000000E+00 z1= 3 0.119542539889564E-06 0.000000000000000E+00 alpha(00000164)=0.000000000000000E+00 beta (00000165)=0.128803038738602E+02 gamma(00000165)=0.128803038738602E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 165 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000165)=0.000000000000000E+00 beta (00000166)=0.137804218909079E+02 gamma(00000166)=0.137804218909079E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 166 z1= 1 0.234437457116536E-06 0.000000000000000E+00 z1= 2 0.135756897568266E-02 0.000000000000000E+00 z1= 3 -.117941811086150E-06 0.000000000000000E+00 alpha(00000166)=0.000000000000000E+00 beta (00000167)=0.126265430728638E+02 gamma(00000167)=0.126265430728638E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 167 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000167)=0.000000000000000E+00 beta (00000168)=0.142374758632978E+02 gamma(00000168)=0.142374758632978E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 168 z1= 1 -.217969120692605E-06 0.000000000000000E+00 z1= 2 -.948231340537512E-03 0.000000000000000E+00 z1= 3 0.110160087818650E-06 0.000000000000000E+00 alpha(00000168)=0.000000000000000E+00 beta (00000169)=0.122837682043739E+02 gamma(00000169)=0.122837682043739E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 169 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000169)=0.000000000000000E+00 beta (00000170)=0.138940525439610E+02 gamma(00000170)=0.138940525439610E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 170 z1= 1 0.202983920986281E-06 0.000000000000000E+00 z1= 2 0.722080888207706E-03 0.000000000000000E+00 z1= 3 -.103015526965885E-06 0.000000000000000E+00 alpha(00000170)=0.000000000000000E+00 beta (00000171)=0.130693570610413E+02 gamma(00000171)=0.130693570610413E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 171 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000171)=0.000000000000000E+00 beta (00000172)=0.136271373056197E+02 gamma(00000172)=0.136271373056197E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 172 z1= 1 -.205111397655940E-06 0.000000000000000E+00 z1= 2 -.623448898792623E-03 0.000000000000000E+00 z1= 3 0.104821436446544E-06 0.000000000000000E+00 alpha(00000172)=0.000000000000000E+00 beta (00000173)=0.121811410949839E+02 gamma(00000173)=0.121811410949839E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 173 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000173)=0.000000000000000E+00 beta (00000174)=0.132891869115395E+02 gamma(00000174)=0.132891869115395E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 174 z1= 1 0.200623938410166E-06 0.000000000000000E+00 z1= 2 0.492930348418833E-03 0.000000000000000E+00 z1= 3 -.103511556671368E-06 0.000000000000000E+00 alpha(00000174)=0.000000000000000E+00 beta (00000175)=0.130057972750287E+02 gamma(00000175)=0.130057972750287E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 175 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000175)=0.000000000000000E+00 beta (00000176)=0.135814610583168E+02 gamma(00000176)=0.135814610583168E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 176 z1= 1 -.205014646288172E-06 0.000000000000000E+00 z1= 2 -.392342829636769E-03 0.000000000000000E+00 z1= 3 0.106968396546535E-06 0.000000000000000E+00 alpha(00000176)=0.000000000000000E+00 beta (00000177)=0.130879592529869E+02 gamma(00000177)=0.130879592529869E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 177 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000177)=0.000000000000000E+00 beta (00000178)=0.138044984351028E+02 gamma(00000178)=0.138044984351028E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 178 z1= 1 0.206341442558246E-06 0.000000000000000E+00 z1= 2 0.246684490774231E-03 0.000000000000000E+00 z1= 3 -.108770666046082E-06 0.000000000000000E+00 alpha(00000178)=0.000000000000000E+00 beta (00000179)=0.125845900860884E+02 gamma(00000179)=0.125845900860884E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 179 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000179)=0.000000000000000E+00 beta (00000180)=0.132832317475780E+02 gamma(00000180)=0.132832317475780E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 180 z1= 1 -.207440446414915E-06 0.000000000000000E+00 z1= 2 -.119711008109966E-03 0.000000000000000E+00 z1= 3 0.110408183863768E-06 0.000000000000000E+00 alpha(00000180)=0.000000000000000E+00 beta (00000181)=0.126678204180505E+02 gamma(00000181)=0.126678204180505E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 181 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000181)=0.000000000000000E+00 beta (00000182)=0.137049298333560E+02 gamma(00000182)=0.137049298333560E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 182 z1= 1 0.201460361724456E-06 0.000000000000000E+00 z1= 2 -.109950516067169E-04 0.000000000000000E+00 z1= 3 -.108068288768920E-06 0.000000000000000E+00 alpha(00000182)=0.000000000000000E+00 beta (00000183)=0.127935571857035E+02 gamma(00000183)=0.127935571857035E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 183 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000183)=0.000000000000000E+00 beta (00000184)=0.134631351715099E+02 gamma(00000184)=0.134631351715099E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 184 z1= 1 -.200902056786802E-06 0.000000000000000E+00 z1= 2 0.135217436169132E-03 0.000000000000000E+00 z1= 3 0.108310154209627E-06 0.000000000000000E+00 alpha(00000184)=0.000000000000000E+00 beta (00000185)=0.130776914950123E+02 gamma(00000185)=0.130776914950123E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 185 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000185)=0.000000000000000E+00 beta (00000186)=0.142074263191247E+02 gamma(00000186)=0.142074263191247E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 186 z1= 1 0.193943404931110E-06 0.000000000000000E+00 z1= 2 -.212626905241133E-03 0.000000000000000E+00 z1= 3 -.105164610131000E-06 0.000000000000000E+00 alpha(00000186)=0.000000000000000E+00 beta (00000187)=0.128286890627456E+02 gamma(00000187)=0.128286890627456E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 187 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000187)=0.000000000000000E+00 beta (00000188)=0.132173773307363E+02 gamma(00000188)=0.132173773307363E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 188 z1= 1 -.198338930082649E-06 0.000000000000000E+00 z1= 2 0.247060463986424E-03 0.000000000000000E+00 z1= 3 0.108180802344741E-06 0.000000000000000E+00 alpha(00000188)=0.000000000000000E+00 beta (00000189)=0.128569842892149E+02 gamma(00000189)=0.128569842892149E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 189 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000189)=0.000000000000000E+00 beta (00000190)=0.142160010189582E+02 gamma(00000190)=0.142160010189582E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 190 z1= 1 0.187715303611065E-06 0.000000000000000E+00 z1= 2 -.240784327909452E-03 0.000000000000000E+00 z1= 3 -.102711203933453E-06 0.000000000000000E+00 alpha(00000190)=0.000000000000000E+00 beta (00000191)=0.126038719410890E+02 gamma(00000191)=0.126038719410890E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 191 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000191)=0.000000000000000E+00 beta (00000192)=0.136580127108817E+02 gamma(00000192)=0.136580127108817E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 192 z1= 1 -.181994831755308E-06 0.000000000000000E+00 z1= 2 0.205578301239019E-03 0.000000000000000E+00 z1= 3 0.997948986352910E-07 0.000000000000000E+00 alpha(00000192)=0.000000000000000E+00 beta (00000193)=0.126334495446990E+02 gamma(00000193)=0.126334495446990E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 193 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000193)=0.000000000000000E+00 beta (00000194)=0.129256731965889E+02 gamma(00000194)=0.129256731965889E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 194 z1= 1 0.186386070474311E-06 0.000000000000000E+00 z1= 2 -.178730351149282E-03 0.000000000000000E+00 z1= 3 -.101970478733689E-06 0.000000000000000E+00 alpha(00000194)=0.000000000000000E+00 beta (00000195)=0.131621044487668E+02 gamma(00000195)=0.131621044487668E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 195 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000195)=0.000000000000000E+00 beta (00000196)=0.138486955858779E+02 gamma(00000196)=0.138486955858779E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 196 z1= 1 -.184036680425052E-06 0.000000000000000E+00 z1= 2 0.980508355754011E-04 0.000000000000000E+00 z1= 3 0.100645370152775E-06 0.000000000000000E+00 alpha(00000196)=0.000000000000000E+00 beta (00000197)=0.133176894071651E+02 gamma(00000197)=0.133176894071651E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 197 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000197)=0.000000000000000E+00 beta (00000198)=0.140086714155079E+02 gamma(00000198)=0.140086714155079E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 198 z1= 1 0.182184814653645E-06 0.000000000000000E+00 z1= 2 0.657784375047432E-04 0.000000000000000E+00 z1= 3 -.997411742384522E-07 0.000000000000000E+00 alpha(00000198)=0.000000000000000E+00 beta (00000199)=0.126231030395377E+02 gamma(00000199)=0.126231030395377E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 199 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000199)=0.000000000000000E+00 beta (00000200)=0.135471361767195E+02 gamma(00000200)=0.135471361767195E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 200 z1= 1 -.178159190705740E-06 0.000000000000000E+00 z1= 2 -.293611902211674E-03 0.000000000000000E+00 z1= 3 0.978802867719793E-07 0.000000000000000E+00 alpha(00000200)=0.000000000000000E+00 beta (00000201)=0.121664423109491E+02 gamma(00000201)=0.121664423109491E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 201 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000201)=0.000000000000000E+00 beta (00000202)=0.137621115996938E+02 gamma(00000202)=0.137621115996938E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 202 z1= 1 0.165816115300227E-06 0.000000000000000E+00 z1= 2 0.484426457942722E-03 0.000000000000000E+00 z1= 3 -.912981633062969E-07 0.000000000000000E+00 alpha(00000202)=0.000000000000000E+00 beta (00000203)=0.128304983916290E+02 gamma(00000203)=0.128304983916290E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 203 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000203)=0.000000000000000E+00 beta (00000204)=0.137473290477797E+02 gamma(00000204)=0.137473290477797E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 204 z1= 1 -.162513874501710E-06 0.000000000000000E+00 z1= 2 -.647559630893734E-03 0.000000000000000E+00 z1= 3 0.890060224158478E-07 0.000000000000000E+00 alpha(00000204)=0.000000000000000E+00 beta (00000205)=0.121748308838468E+02 gamma(00000205)=0.121748308838468E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 205 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000205)=0.000000000000000E+00 beta (00000206)=0.135409170199911E+02 gamma(00000206)=0.135409170199911E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 206 z1= 1 0.153499317420008E-06 0.000000000000000E+00 z1= 2 0.682206815361810E-03 0.000000000000000E+00 z1= 3 -.834731126643398E-07 0.000000000000000E+00 alpha(00000206)=0.000000000000000E+00 beta (00000207)=0.125235319645082E+02 gamma(00000207)=0.125235319645082E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 207 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000207)=0.000000000000000E+00 beta (00000208)=0.134816822707254E+02 gamma(00000208)=0.134816822707254E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 208 z1= 1 -.152088700761371E-06 0.000000000000000E+00 z1= 2 -.698820678296429E-03 0.000000000000000E+00 z1= 3 0.824473932446203E-07 0.000000000000000E+00 alpha(00000208)=0.000000000000000E+00 beta (00000209)=0.124235678517815E+02 gamma(00000209)=0.124235678517815E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 209 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000209)=0.000000000000000E+00 beta (00000210)=0.133912966220254E+02 gamma(00000210)=0.133912966220254E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 210 z1= 1 0.151289843405237E-06 0.000000000000000E+00 z1= 2 0.757191941480030E-03 0.000000000000000E+00 z1= 3 -.820457969337267E-07 0.000000000000000E+00 alpha(00000210)=0.000000000000000E+00 beta (00000211)=0.132521027658954E+02 gamma(00000211)=0.132521027658954E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 211 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000211)=0.000000000000000E+00 beta (00000212)=0.130575391660017E+02 gamma(00000212)=0.130575391660017E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 212 z1= 1 -.162167928932644E-06 0.000000000000000E+00 z1= 2 -.799450345615278E-03 0.000000000000000E+00 z1= 3 0.878994792098253E-07 0.000000000000000E+00 alpha(00000212)=0.000000000000000E+00 beta (00000213)=0.121344235752825E+02 gamma(00000213)=0.121344235752825E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 213 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000213)=0.000000000000000E+00 beta (00000214)=0.136940760761102E+02 gamma(00000214)=0.136940760761102E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 214 z1= 1 0.151519580904227E-06 0.000000000000000E+00 z1= 2 0.547085417591435E-03 0.000000000000000E+00 z1= 3 -.823170712027253E-07 0.000000000000000E+00 alpha(00000214)=0.000000000000000E+00 beta (00000215)=0.130546302824771E+02 gamma(00000215)=0.130546302824771E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 215 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000215)=0.000000000000000E+00 beta (00000216)=0.139907532091655E+02 gamma(00000216)=0.139907532091655E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 216 z1= 1 -.148488024174186E-06 0.000000000000000E+00 z1= 2 -.111487203112727E-03 0.000000000000000E+00 z1= 3 0.807342780085804E-07 0.000000000000000E+00 alpha(00000216)=0.000000000000000E+00 beta (00000217)=0.131053420015691E+02 gamma(00000217)=0.131053420015691E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 217 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000217)=0.000000000000000E+00 beta (00000218)=0.136145386131074E+02 gamma(00000218)=0.136145386131074E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 218 z1= 1 0.149409045414146E-06 0.000000000000000E+00 z1= 2 -.470224125175739E-03 0.000000000000000E+00 z1= 3 -.812846367288745E-07 0.000000000000000E+00 alpha(00000218)=0.000000000000000E+00 beta (00000219)=0.130737116985311E+02 gamma(00000219)=0.130737116985311E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 219 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000219)=0.000000000000000E+00 beta (00000220)=0.137872366763051E+02 gamma(00000220)=0.137872366763051E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 220 z1= 1 -.147246040728844E-06 0.000000000000000E+00 z1= 2 0.106670437897619E-02 0.000000000000000E+00 z1= 3 0.804746735142119E-07 0.000000000000000E+00 alpha(00000220)=0.000000000000000E+00 beta (00000221)=0.128028776553102E+02 gamma(00000221)=0.128028776553102E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 221 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000221)=0.000000000000000E+00 beta (00000222)=0.137338336578714E+02 gamma(00000222)=0.137338336578714E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 222 z1= 1 0.142394381828911E-06 0.000000000000000E+00 z1= 2 -.155526651353734E-02 0.000000000000000E+00 z1= 3 -.783908734122317E-07 0.000000000000000E+00 alpha(00000222)=0.000000000000000E+00 beta (00000223)=0.122029811460599E+02 gamma(00000223)=0.122029811460599E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 223 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000223)=0.000000000000000E+00 beta (00000224)=0.131574238715080E+02 gamma(00000224)=0.131574238715080E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 224 z1= 1 -.137646482516272E-06 0.000000000000000E+00 z1= 2 0.194535473525231E-02 0.000000000000000E+00 z1= 3 0.767059028935970E-07 0.000000000000000E+00 alpha(00000224)=0.000000000000000E+00 beta (00000225)=0.121479991632846E+02 gamma(00000225)=0.121479991632846E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 225 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000225)=0.000000000000000E+00 beta (00000226)=0.137841951403626E+02 gamma(00000226)=0.137841951403626E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 226 z1= 1 0.127315148147969E-06 0.000000000000000E+00 z1= 2 -.212621101081405E-02 0.000000000000000E+00 z1= 3 -.721071067493818E-07 0.000000000000000E+00 alpha(00000226)=0.000000000000000E+00 beta (00000227)=0.128716874936413E+02 gamma(00000227)=0.128716874936413E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 227 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000227)=0.000000000000000E+00 beta (00000228)=0.133599345905845E+02 gamma(00000228)=0.133599345905845E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 228 z1= 1 -.128119928883945E-06 0.000000000000000E+00 z1= 2 0.235182748667997E-02 0.000000000000000E+00 z1= 3 0.737615711495247E-07 0.000000000000000E+00 alpha(00000228)=0.000000000000000E+00 beta (00000229)=0.126508895118926E+02 gamma(00000229)=0.126508895118926E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 229 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000229)=0.000000000000000E+00 beta (00000230)=0.130544706251323E+02 gamma(00000230)=0.130544706251323E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 230 z1= 1 0.128490366164621E-06 0.000000000000000E+00 z1= 2 -.250683102188842E-02 0.000000000000000E+00 z1= 3 -.750727944973605E-07 0.000000000000000E+00 alpha(00000230)=0.000000000000000E+00 beta (00000231)=0.127900869524008E+02 gamma(00000231)=0.127900869524008E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 231 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000231)=0.000000000000000E+00 beta (00000232)=0.139958191207757E+02 gamma(00000232)=0.139958191207757E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 232 z1= 1 -.120537984307431E-06 0.000000000000000E+00 z1= 2 0.239193962554410E-02 0.000000000000000E+00 z1= 3 0.709283526714472E-07 0.000000000000000E+00 alpha(00000232)=0.000000000000000E+00 beta (00000233)=0.131324637557998E+02 gamma(00000233)=0.131324637557998E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 233 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000233)=0.000000000000000E+00 beta (00000234)=0.136723139449772E+02 gamma(00000234)=0.136723139449772E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 234 z1= 1 0.118021584158412E-06 0.000000000000000E+00 z1= 2 -.234312540909327E-02 0.000000000000000E+00 z1= 3 -.696426941067306E-07 0.000000000000000E+00 alpha(00000234)=0.000000000000000E+00 beta (00000235)=0.130063400140468E+02 gamma(00000235)=0.130063400140468E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 235 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000235)=0.000000000000000E+00 beta (00000236)=0.136793778181069E+02 gamma(00000236)=0.136793778181069E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 236 z1= 1 -.113923036792335E-06 0.000000000000000E+00 z1= 2 0.220553121834077E-02 0.000000000000000E+00 z1= 3 0.673492331442187E-07 0.000000000000000E+00 alpha(00000236)=0.000000000000000E+00 beta (00000237)=0.129605175197118E+02 gamma(00000237)=0.129605175197118E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 237 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000237)=0.000000000000000E+00 beta (00000238)=0.135509214178767E+02 gamma(00000238)=0.135509214178767E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 238 z1= 1 0.110303085196911E-06 0.000000000000000E+00 z1= 2 -.200611762075813E-02 0.000000000000000E+00 z1= 3 -.653670782029513E-07 0.000000000000000E+00 alpha(00000238)=0.000000000000000E+00 beta (00000239)=0.129572490233911E+02 gamma(00000239)=0.129572490233911E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 239 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000239)=0.000000000000000E+00 beta (00000240)=0.141677996433526E+02 gamma(00000240)=0.141677996433526E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 240 z1= 1 -.101607513224369E-06 0.000000000000000E+00 z1= 2 0.177694942266388E-02 0.000000000000000E+00 z1= 3 0.602904839400935E-07 0.000000000000000E+00 alpha(00000240)=0.000000000000000E+00 beta (00000241)=0.127858681161235E+02 gamma(00000241)=0.127858681161235E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 241 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000241)=0.000000000000000E+00 beta (00000242)=0.137129412699227E+02 gamma(00000242)=0.137129412699227E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 242 z1= 1 0.951933928525998E-07 0.000000000000000E+00 z1= 2 -.158884006303613E-02 0.000000000000000E+00 z1= 3 -.565074541593281E-07 0.000000000000000E+00 alpha(00000242)=0.000000000000000E+00 beta (00000243)=0.128810622489208E+02 gamma(00000243)=0.128810622489208E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 243 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000243)=0.000000000000000E+00 beta (00000244)=0.129023930005621E+02 gamma(00000244)=0.129023930005621E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 244 z1= 1 -.955009360802464E-07 0.000000000000000E+00 z1= 2 0.153733014970535E-02 0.000000000000000E+00 z1= 3 0.569195071503398E-07 0.000000000000000E+00 alpha(00000244)=0.000000000000000E+00 beta (00000245)=0.122178631835321E+02 gamma(00000245)=0.122178631835321E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 245 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000245)=0.000000000000000E+00 beta (00000246)=0.134656011766618E+02 gamma(00000246)=0.134656011766618E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 246 z1= 1 0.876575416669089E-07 0.000000000000000E+00 z1= 2 -.138150401459790E-02 0.000000000000000E+00 z1= 3 -.525792041362102E-07 0.000000000000000E+00 alpha(00000246)=0.000000000000000E+00 beta (00000247)=0.123261764728386E+02 gamma(00000247)=0.123261764728386E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 247 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000247)=0.000000000000000E+00 beta (00000248)=0.135306313593800E+02 gamma(00000248)=0.135306313593800E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 248 z1= 1 -.806957515995209E-07 0.000000000000000E+00 z1= 2 0.129946658967851E-02 0.000000000000000E+00 z1= 3 0.488151402823099E-07 0.000000000000000E+00 alpha(00000248)=0.000000000000000E+00 beta (00000249)=0.130329843959403E+02 gamma(00000249)=0.130329843959403E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 249 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000249)=0.000000000000000E+00 beta (00000250)=0.133723255937934E+02 gamma(00000250)=0.133723255937934E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 250 z1= 1 0.787172672676428E-07 0.000000000000000E+00 z1= 2 -.133833267210186E-02 0.000000000000000E+00 z1= 3 -.483043002165321E-07 0.000000000000000E+00 alpha(00000250)=0.000000000000000E+00 beta (00000251)=0.125956797331848E+02 gamma(00000251)=0.125956797331848E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 251 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000251)=0.000000000000000E+00 beta (00000252)=0.136070100772399E+02 gamma(00000252)=0.136070100772399E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 252 z1= 1 -.740816691515572E-07 0.000000000000000E+00 z1= 2 0.138841636550923E-02 0.000000000000000E+00 z1= 3 0.463805060176101E-07 0.000000000000000E+00 alpha(00000252)=0.000000000000000E+00 beta (00000253)=0.127858721976897E+02 gamma(00000253)=0.127858721976897E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 253 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000253)=0.000000000000000E+00 beta (00000254)=0.132358027576445E+02 gamma(00000254)=0.132358027576445E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 254 z1= 1 0.739272733199341E-07 0.000000000000000E+00 z1= 2 -.153710181773027E-02 0.000000000000000E+00 z1= 3 -.475180528588387E-07 0.000000000000000E+00 alpha(00000254)=0.000000000000000E+00 beta (00000255)=0.121427589574272E+02 gamma(00000255)=0.121427589574272E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 255 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000255)=0.000000000000000E+00 beta (00000256)=0.143751573574633E+02 gamma(00000256)=0.143751573574633E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 256 z1= 1 -.643819489552430E-07 0.000000000000000E+00 z1= 2 0.146830622829034E-02 0.000000000000000E+00 z1= 3 0.426020136303092E-07 0.000000000000000E+00 alpha(00000256)=0.000000000000000E+00 beta (00000257)=0.125263231567145E+02 gamma(00000257)=0.125263231567145E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 257 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000257)=0.000000000000000E+00 beta (00000258)=0.133616889237217E+02 gamma(00000258)=0.133616889237217E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 258 z1= 1 0.619009537725090E-07 0.000000000000000E+00 z1= 2 -.169132323629850E-02 0.000000000000000E+00 z1= 3 -.423340183472259E-07 0.000000000000000E+00 alpha(00000258)=0.000000000000000E+00 beta (00000259)=0.127923864670356E+02 gamma(00000259)=0.127923864670356E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 259 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000259)=0.000000000000000E+00 beta (00000260)=0.137669521919653E+02 gamma(00000260)=0.137669521919653E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 260 z1= 1 -.608182848431740E-07 0.000000000000000E+00 z1= 2 0.192259470902553E-02 0.000000000000000E+00 z1= 3 0.427882656056590E-07 0.000000000000000E+00 alpha(00000260)=0.000000000000000E+00 beta (00000261)=0.126234900918278E+02 gamma(00000261)=0.126234900918278E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 261 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000261)=0.000000000000000E+00 beta (00000262)=0.138366559338050E+02 gamma(00000262)=0.138366559338050E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 262 z1= 1 0.585573168634945E-07 0.000000000000000E+00 z1= 2 -.210619225136801E-02 0.000000000000000E+00 z1= 3 -.422936053500584E-07 0.000000000000000E+00 alpha(00000262)=0.000000000000000E+00 beta (00000263)=0.128959923477623E+02 gamma(00000263)=0.128959923477623E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 263 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000263)=0.000000000000000E+00 beta (00000264)=0.133015482307241E+02 gamma(00000264)=0.133015482307241E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 264 z1= 1 -.577232833814598E-07 0.000000000000000E+00 z1= 2 0.231913970376895E-02 0.000000000000000E+00 z1= 3 0.425508295669738E-07 0.000000000000000E+00 alpha(00000264)=0.000000000000000E+00 beta (00000265)=0.130100448188909E+02 gamma(00000265)=0.130100448188909E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 265 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000265)=0.000000000000000E+00 beta (00000266)=0.135350642713244E+02 gamma(00000266)=0.135350642713244E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 266 z1= 1 0.571749457795728E-07 0.000000000000000E+00 z1= 2 -.237155953400504E-02 0.000000000000000E+00 z1= 3 -.431002296900256E-07 0.000000000000000E+00 alpha(00000266)=0.000000000000000E+00 beta (00000267)=0.128615048100188E+02 gamma(00000267)=0.128615048100188E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 267 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000267)=0.000000000000000E+00 beta (00000268)=0.133347948609542E+02 gamma(00000268)=0.133347948609542E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 268 z1= 1 -.566946744846170E-07 0.000000000000000E+00 z1= 2 0.250973849257287E-02 0.000000000000000E+00 z1= 3 0.435312474413550E-07 0.000000000000000E+00 alpha(00000268)=0.000000000000000E+00 beta (00000269)=0.121018650084575E+02 gamma(00000269)=0.121018650084575E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 269 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000269)=0.000000000000000E+00 beta (00000270)=0.135291853106590E+02 gamma(00000270)=0.135291853106590E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 270 z1= 1 0.522910119909320E-07 0.000000000000000E+00 z1= 2 -.244006177541970E-02 0.000000000000000E+00 z1= 3 -.409821580152694E-07 0.000000000000000E+00 alpha(00000270)=0.000000000000000E+00 beta (00000271)=0.125622427312431E+02 gamma(00000271)=0.125622427312431E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 271 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000271)=0.000000000000000E+00 beta (00000272)=0.139105902226393E+02 gamma(00000272)=0.139105902226393E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 272 z1= 1 -.478757663782345E-07 0.000000000000000E+00 z1= 2 0.237694694208992E-02 0.000000000000000E+00 z1= 3 0.382421890014403E-07 0.000000000000000E+00 alpha(00000272)=0.000000000000000E+00 beta (00000273)=0.128218370180376E+02 gamma(00000273)=0.128218370180376E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 273 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000273)=0.000000000000000E+00 beta (00000274)=0.138030541537637E+02 gamma(00000274)=0.138030541537637E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 274 z1= 1 0.432625975252399E-07 0.000000000000000E+00 z1= 2 -.231998267356140E-02 0.000000000000000E+00 z1= 3 -.355763934574947E-07 0.000000000000000E+00 alpha(00000274)=0.000000000000000E+00 beta (00000275)=0.131283512000296E+02 gamma(00000275)=0.131283512000296E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 275 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000275)=0.000000000000000E+00 beta (00000276)=0.134506355303808E+02 gamma(00000276)=0.134506355303808E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 276 z1= 1 -.411800595125425E-07 0.000000000000000E+00 z1= 2 0.237952251205500E-02 0.000000000000000E+00 z1= 3 0.348975195429459E-07 0.000000000000000E+00 alpha(00000276)=0.000000000000000E+00 beta (00000277)=0.120983809738800E+02 gamma(00000277)=0.120983809738800E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 277 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000277)=0.000000000000000E+00 beta (00000278)=0.140362622368121E+02 gamma(00000278)=0.140362622368121E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 278 z1= 1 0.351232457901016E-07 0.000000000000000E+00 z1= 2 -.218939802734524E-02 0.000000000000000E+00 z1= 3 -.312587654417457E-07 0.000000000000000E+00 alpha(00000278)=0.000000000000000E+00 beta (00000279)=0.128343758612371E+02 gamma(00000279)=0.128343758612371E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 279 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000279)=0.000000000000000E+00 beta (00000280)=0.132035188613513E+02 gamma(00000280)=0.132035188613513E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 280 z1= 1 -.332809323901756E-07 0.000000000000000E+00 z1= 2 0.224737425063818E-02 0.000000000000000E+00 z1= 3 0.312746951654317E-07 0.000000000000000E+00 alpha(00000280)=0.000000000000000E+00 beta (00000281)=0.126296275062202E+02 gamma(00000281)=0.126296275062202E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 281 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000281)=0.000000000000000E+00 beta (00000282)=0.131164947330415E+02 gamma(00000282)=0.131164947330415E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 282 z1= 1 0.308823459322510E-07 0.000000000000000E+00 z1= 2 -.230872017127892E-02 0.000000000000000E+00 z1= 3 -.313165773106988E-07 0.000000000000000E+00 alpha(00000282)=0.000000000000000E+00 beta (00000283)=0.131275407328408E+02 gamma(00000283)=0.131275407328408E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 283 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000283)=0.000000000000000E+00 beta (00000284)=0.143339211418212E+02 gamma(00000284)=0.143339211418212E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 284 z1= 1 -.253429492799370E-07 0.000000000000000E+00 z1= 2 0.225769641176012E-02 0.000000000000000E+00 z1= 3 0.284558113553961E-07 0.000000000000000E+00 alpha(00000284)=0.000000000000000E+00 beta (00000285)=0.125045231295963E+02 gamma(00000285)=0.125045231295963E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 285 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000285)=0.000000000000000E+00 beta (00000286)=0.132261951215463E+02 gamma(00000286)=0.132261951215463E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 286 z1= 1 0.192701197186673E-07 0.000000000000000E+00 z1= 2 -.229637379272091E-02 0.000000000000000E+00 z1= 3 -.262508460763353E-07 0.000000000000000E+00 alpha(00000286)=0.000000000000000E+00 beta (00000287)=0.120364518184878E+02 gamma(00000287)=0.120364518184878E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 287 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000287)=0.000000000000000E+00 beta (00000288)=0.137285309271180E+02 gamma(00000288)=0.137285309271180E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 288 z1= 1 -.128663784930080E-07 0.000000000000000E+00 z1= 2 0.220300233887579E-02 0.000000000000000E+00 z1= 3 0.230041304044972E-07 0.000000000000000E+00 alpha(00000288)=0.000000000000000E+00 beta (00000289)=0.130404227533478E+02 gamma(00000289)=0.130404227533478E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 289 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000289)=0.000000000000000E+00 beta (00000290)=0.131655972350514E+02 gamma(00000290)=0.131655972350514E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 290 z1= 1 0.809358356897161E-08 0.000000000000000E+00 z1= 2 -.232322166911204E-02 0.000000000000000E+00 z1= 3 -.231369282479655E-07 0.000000000000000E+00 alpha(00000290)=0.000000000000000E+00 beta (00000291)=0.126881195032582E+02 gamma(00000291)=0.126881195032582E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 291 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000291)=0.000000000000000E+00 beta (00000292)=0.143986425469521E+02 gamma(00000292)=0.143986425469521E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 292 z1= 1 -.239964215078409E-08 0.000000000000000E+00 z1= 2 0.212981665337911E-02 0.000000000000000E+00 z1= 3 0.198895700305132E-07 0.000000000000000E+00 alpha(00000292)=0.000000000000000E+00 beta (00000293)=0.126192736982987E+02 gamma(00000293)=0.126192736982987E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 293 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000293)=0.000000000000000E+00 beta (00000294)=0.129212351149409E+02 gamma(00000294)=0.129212351149409E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 294 z1= 1 -.341279760875113E-08 0.000000000000000E+00 z1= 2 -.208167263119834E-02 0.000000000000000E+00 z1= 3 -.195323642086798E-07 0.000000000000000E+00 alpha(00000294)=0.000000000000000E+00 beta (00000295)=0.127211001047508E+02 gamma(00000295)=0.127211001047508E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 295 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000295)=0.000000000000000E+00 beta (00000296)=0.133265590853986E+02 gamma(00000296)=0.133265590853986E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 296 z1= 1 0.648701263192275E-08 0.000000000000000E+00 z1= 2 0.198536954995334E-02 0.000000000000000E+00 z1= 3 0.196456490349152E-07 0.000000000000000E+00 alpha(00000296)=0.000000000000000E+00 beta (00000297)=0.131099551588687E+02 gamma(00000297)=0.131099551588687E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 297 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000297)=0.000000000000000E+00 beta (00000298)=0.140220036161361E+02 gamma(00000298)=0.140220036161361E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 298 z1= 1 -.905025894330780E-08 0.000000000000000E+00 z1= 2 -.195918295053164E-02 0.000000000000000E+00 z1= 3 -.203027387548444E-07 0.000000000000000E+00 alpha(00000298)=0.000000000000000E+00 beta (00000299)=0.121716770669527E+02 gamma(00000299)=0.121716770669527E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 299 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000299)=0.000000000000000E+00 beta (00000300)=0.140891011477287E+02 gamma(00000300)=0.140891011477287E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 300 z1= 1 0.109557950556723E-07 0.000000000000000E+00 z1= 2 0.188318113358975E-02 0.000000000000000E+00 z1= 3 0.182279392178060E-07 0.000000000000000E+00 alpha(00000300)=0.000000000000000E+00 beta (00000301)=0.124126662020496E+02 gamma(00000301)=0.124126662020496E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 301 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000301)=0.000000000000000E+00 beta (00000302)=0.133562808700141E+02 gamma(00000302)=0.133562808700141E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 302 z1= 1 -.161324911545843E-07 0.000000000000000E+00 z1= 2 -.193512181904181E-02 0.000000000000000E+00 z1= 3 -.176480221349183E-07 0.000000000000000E+00 alpha(00000302)=0.000000000000000E+00 beta (00000303)=0.125600211132069E+02 gamma(00000303)=0.125600211132069E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 303 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000303)=0.000000000000000E+00 beta (00000304)=0.142273700208388E+02 gamma(00000304)=0.142273700208388E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 304 z1= 1 0.197506532183776E-07 0.000000000000000E+00 z1= 2 0.175267682016622E-02 0.000000000000000E+00 z1= 3 0.144353957432257E-07 0.000000000000000E+00 alpha(00000304)=0.000000000000000E+00 beta (00000305)=0.128686437970756E+02 gamma(00000305)=0.128686437970756E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 305 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000305)=0.000000000000000E+00 beta (00000306)=0.136701085332640E+02 gamma(00000306)=0.136701085332640E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 306 z1= 1 -.253247639100604E-07 0.000000000000000E+00 z1= 2 -.172438591607447E-02 0.000000000000000E+00 z1= 3 -.147608448328868E-07 0.000000000000000E+00 alpha(00000306)=0.000000000000000E+00 beta (00000307)=0.130501297094916E+02 gamma(00000307)=0.130501297094916E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 307 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000307)=0.000000000000000E+00 beta (00000308)=0.134125125710327E+02 gamma(00000308)=0.134125125710327E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 308 z1= 1 0.271927282032881E-07 0.000000000000000E+00 z1= 2 0.173724371432127E-02 0.000000000000000E+00 z1= 3 0.153087858102002E-07 0.000000000000000E+00 alpha(00000308)=0.000000000000000E+00 beta (00000309)=0.131013478455165E+02 gamma(00000309)=0.131013478455165E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 309 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000309)=0.000000000000000E+00 beta (00000310)=0.132534463410764E+02 gamma(00000310)=0.132534463410764E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 310 z1= 1 -.311404902532744E-07 0.000000000000000E+00 z1= 2 -.174203581563493E-02 0.000000000000000E+00 z1= 3 -.177322549383763E-07 0.000000000000000E+00 alpha(00000310)=0.000000000000000E+00 beta (00000311)=0.124054362863740E+02 gamma(00000311)=0.124054362863740E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 311 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000311)=0.000000000000000E+00 beta (00000312)=0.130844062634738E+02 gamma(00000312)=0.130844062634738E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 312 z1= 1 0.337295894721479E-07 0.000000000000000E+00 z1= 2 0.156037666399872E-02 0.000000000000000E+00 z1= 3 0.157187474304071E-07 0.000000000000000E+00 alpha(00000312)=0.000000000000000E+00 beta (00000313)=0.120978151068232E+02 gamma(00000313)=0.120978151068232E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 313 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000313)=0.000000000000000E+00 beta (00000314)=0.134445472336120E+02 gamma(00000314)=0.134445472336120E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 314 z1= 1 -.384592298563469E-07 0.000000000000000E+00 z1= 2 -.122592717383776E-02 0.000000000000000E+00 z1= 3 -.151761748443178E-07 0.000000000000000E+00 alpha(00000314)=0.000000000000000E+00 beta (00000315)=0.125927304473802E+02 gamma(00000315)=0.125927304473802E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 315 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000315)=0.000000000000000E+00 beta (00000316)=0.137111750702075E+02 gamma(00000316)=0.137111750702075E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 316 z1= 1 0.389250026646901E-07 0.000000000000000E+00 z1= 2 0.855260349592315E-03 0.000000000000000E+00 z1= 3 0.104563011312604E-07 0.000000000000000E+00 alpha(00000316)=0.000000000000000E+00 beta (00000317)=0.116397898317132E+02 gamma(00000317)=0.116397898317132E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 317 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000317)=0.000000000000000E+00 beta (00000318)=0.138057725812874E+02 gamma(00000318)=0.138057725812874E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 318 z1= 1 -.431178755412771E-07 0.000000000000000E+00 z1= 2 -.302871395976796E-03 0.000000000000000E+00 z1= 3 -.126317797045331E-07 0.000000000000000E+00 alpha(00000318)=0.000000000000000E+00 beta (00000319)=0.130198609067111E+02 gamma(00000319)=0.130198609067111E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 319 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000319)=0.000000000000000E+00 beta (00000320)=0.140876698508779E+02 gamma(00000320)=0.140876698508779E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 320 z1= 1 0.394589965888557E-07 0.000000000000000E+00 z1= 2 -.827489015067483E-04 0.000000000000000E+00 z1= 3 0.545267414363672E-08 0.000000000000000E+00 alpha(00000320)=0.000000000000000E+00 beta (00000321)=0.119273601222837E+02 gamma(00000321)=0.119273601222837E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 321 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000321)=0.000000000000000E+00 beta (00000322)=0.136098720997389E+02 gamma(00000322)=0.136098720997389E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 322 z1= 1 -.467604410062453E-07 0.000000000000000E+00 z1= 2 0.430990419420331E-03 0.000000000000000E+00 z1= 3 -.152535919016475E-07 0.000000000000000E+00 alpha(00000322)=0.000000000000000E+00 beta (00000323)=0.120181394626614E+02 gamma(00000323)=0.120181394626614E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 323 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000323)=0.000000000000000E+00 beta (00000324)=0.139276570983250E+02 gamma(00000324)=0.139276570983250E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 324 z1= 1 0.336988052577775E-07 0.000000000000000E+00 z1= 2 -.594424573666518E-03 0.000000000000000E+00 z1= 3 0.304262845007928E-08 0.000000000000000E+00 alpha(00000324)=0.000000000000000E+00 beta (00000325)=0.130537304872655E+02 gamma(00000325)=0.130537304872655E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 325 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000325)=0.000000000000000E+00 beta (00000326)=0.143288215271840E+02 gamma(00000326)=0.143288215271840E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 326 z1= 1 -.498761933272153E-07 0.000000000000000E+00 z1= 2 0.579444541429218E-03 0.000000000000000E+00 z1= 3 -.226259050554534E-07 0.000000000000000E+00 alpha(00000326)=0.000000000000000E+00 beta (00000327)=0.128337305696836E+02 gamma(00000327)=0.128337305696836E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 327 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000327)=0.000000000000000E+00 beta (00000328)=0.132683506986780E+02 gamma(00000328)=0.132683506986780E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 328 z1= 1 0.352342510493396E-07 0.000000000000000E+00 z1= 2 -.455116985648579E-03 0.000000000000000E+00 z1= 3 0.653367932700781E-08 0.000000000000000E+00 alpha(00000328)=0.000000000000000E+00 beta (00000329)=0.130584935843596E+02 gamma(00000329)=0.130584935843596E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 329 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000329)=0.000000000000000E+00 beta (00000330)=0.143993541458764E+02 gamma(00000330)=0.143993541458764E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 330 z1= 1 -.533544559997833E-07 0.000000000000000E+00 z1= 2 0.284992236659255E-03 0.000000000000000E+00 z1= 3 -.287943345912269E-07 0.000000000000000E+00 alpha(00000330)=0.000000000000000E+00 beta (00000331)=0.124219617095914E+02 gamma(00000331)=0.124219617095914E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 331 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000331)=0.000000000000000E+00 beta (00000332)=0.140465447115775E+02 gamma(00000332)=0.140465447115775E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 332 z1= 1 0.382492530114076E-07 0.000000000000000E+00 z1= 2 -.144279854051417E-03 0.000000000000000E+00 z1= 3 0.103766006815225E-07 0.000000000000000E+00 alpha(00000332)=0.000000000000000E+00 beta (00000333)=0.126294473932006E+02 gamma(00000333)=0.126294473932006E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 333 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000333)=0.000000000000000E+00 beta (00000334)=0.131244561157870E+02 gamma(00000334)=0.131244561157870E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 334 z1= 1 -.615651525983155E-07 0.000000000000000E+00 z1= 2 0.769522441910120E-04 0.000000000000000E+00 z1= 3 -.294604475838586E-07 0.000000000000000E+00 alpha(00000334)=0.000000000000000E+00 beta (00000335)=0.129881280900568E+02 gamma(00000335)=0.129881280900568E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 335 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000335)=0.000000000000000E+00 beta (00000336)=0.130280967299536E+02 gamma(00000336)=0.130280967299536E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 336 z1= 1 0.559606604371571E-07 0.000000000000000E+00 z1= 2 -.100777327615995E-03 0.000000000000000E+00 z1= 3 0.163940320112917E-07 0.000000000000000E+00 alpha(00000336)=0.000000000000000E+00 beta (00000337)=0.130682112567211E+02 gamma(00000337)=0.130682112567211E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 337 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000337)=0.000000000000000E+00 beta (00000338)=0.127516465884787E+02 gamma(00000338)=0.127516465884787E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 338 z1= 1 -.806602463822650E-07 0.000000000000000E+00 z1= 2 0.243958759599355E-03 0.000000000000000E+00 z1= 3 -.404878510027926E-07 0.000000000000000E+00 alpha(00000338)=0.000000000000000E+00 beta (00000339)=0.141532114111175E+02 gamma(00000339)=0.141532114111175E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 339 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000339)=0.000000000000000E+00 beta (00000340)=0.138348746295753E+02 gamma(00000340)=0.138348746295753E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 340 z1= 1 0.718150508192961E-07 0.000000000000000E+00 z1= 2 -.396103991409022E-03 0.000000000000000E+00 z1= 3 0.241705371659031E-07 0.000000000000000E+00 alpha(00000340)=0.000000000000000E+00 beta (00000341)=0.123991825575011E+02 gamma(00000341)=0.123991825575011E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 341 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000341)=0.000000000000000E+00 beta (00000342)=0.141634434878159E+02 gamma(00000342)=0.141634434878159E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 342 z1= 1 -.874159424421247E-07 0.000000000000000E+00 z1= 2 0.570270534073332E-03 0.000000000000000E+00 z1= 3 -.415439793479441E-07 0.000000000000000E+00 alpha(00000342)=0.000000000000000E+00 beta (00000343)=0.128968242427361E+02 gamma(00000343)=0.128968242427361E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 343 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000343)=0.000000000000000E+00 beta (00000344)=0.138554459715658E+02 gamma(00000344)=0.138554459715658E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 344 z1= 1 0.758931043508791E-07 0.000000000000000E+00 z1= 2 -.851538592784435E-03 0.000000000000000E+00 z1= 3 0.253708547950210E-07 0.000000000000000E+00 alpha(00000344)=0.000000000000000E+00 beta (00000345)=0.123173002547365E+02 gamma(00000345)=0.123173002547365E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 345 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000345)=0.000000000000000E+00 beta (00000346)=0.142095168049068E+02 gamma(00000346)=0.142095168049068E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 346 z1= 1 -.861548041979424E-07 0.000000000000000E+00 z1= 2 0.103444113499834E-02 0.000000000000000E+00 z1= 3 -.378830926190093E-07 0.000000000000000E+00 alpha(00000346)=0.000000000000000E+00 beta (00000347)=0.122960743905637E+02 gamma(00000347)=0.122960743905637E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 347 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000347)=0.000000000000000E+00 beta (00000348)=0.144023902313605E+02 gamma(00000348)=0.144023902313605E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 348 z1= 1 0.758363428153032E-07 0.000000000000000E+00 z1= 2 -.123897580084718E-02 0.000000000000000E+00 z1= 3 0.272100654554732E-07 0.000000000000000E+00 alpha(00000348)=0.000000000000000E+00 beta (00000349)=0.120668953169446E+02 gamma(00000349)=0.120668953169446E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 349 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000349)=0.000000000000000E+00 beta (00000350)=0.127375395197525E+02 gamma(00000350)=0.127375395197525E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 350 z1= 1 -.906172674909264E-07 0.000000000000000E+00 z1= 2 0.160472578797826E-02 0.000000000000000E+00 z1= 3 -.384267014378031E-07 0.000000000000000E+00 alpha(00000350)=0.000000000000000E+00 beta (00000351)=0.127919998790021E+02 gamma(00000351)=0.127919998790021E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 351 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000351)=0.000000000000000E+00 beta (00000352)=0.140264819225396E+02 gamma(00000352)=0.140264819225396E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 352 z1= 1 0.893739545240226E-07 0.000000000000000E+00 z1= 2 -.166724755901712E-02 0.000000000000000E+00 z1= 3 0.359649277428061E-07 0.000000000000000E+00 alpha(00000352)=0.000000000000000E+00 beta (00000353)=0.124615860877462E+02 gamma(00000353)=0.124615860877462E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 353 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000353)=0.000000000000000E+00 beta (00000354)=0.134491972821381E+02 gamma(00000354)=0.134491972821381E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 354 z1= 1 -.983837923963261E-07 0.000000000000000E+00 z1= 2 0.167834812267859E-02 0.000000000000000E+00 z1= 3 -.429412693776104E-07 0.000000000000000E+00 alpha(00000354)=0.000000000000000E+00 beta (00000355)=0.125822928367823E+02 gamma(00000355)=0.125822928367823E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 355 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000355)=0.000000000000000E+00 beta (00000356)=0.134641916293797E+02 gamma(00000356)=0.134641916293797E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 356 z1= 1 0.100759212178642E-06 0.000000000000000E+00 z1= 2 -.164544613150651E-02 0.000000000000000E+00 z1= 3 0.458968926149222E-07 0.000000000000000E+00 alpha(00000356)=0.000000000000000E+00 beta (00000357)=0.124475434014537E+02 gamma(00000357)=0.124475434014537E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 357 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000357)=0.000000000000000E+00 beta (00000358)=0.139970423649304E+02 gamma(00000358)=0.139970423649304E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 358 z1= 1 -.999381071023486E-07 0.000000000000000E+00 z1= 2 0.137459819310750E-02 0.000000000000000E+00 z1= 3 -.519991627938332E-07 0.000000000000000E+00 alpha(00000358)=0.000000000000000E+00 beta (00000359)=0.126737655161189E+02 gamma(00000359)=0.126737655161189E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 359 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000359)=0.000000000000000E+00 beta (00000360)=0.139404668429830E+02 gamma(00000360)=0.139404668429830E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 360 z1= 1 0.997061501556429E-07 0.000000000000000E+00 z1= 2 -.985699094979011E-03 0.000000000000000E+00 z1= 3 0.558198121723566E-07 0.000000000000000E+00 alpha(00000360)=0.000000000000000E+00 beta (00000361)=0.126828449185231E+02 gamma(00000361)=0.126828449185231E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 361 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000361)=0.000000000000000E+00 beta (00000362)=0.134466719645668E+02 gamma(00000362)=0.134466719645668E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 362 z1= 1 -.105547600169880E-06 0.000000000000000E+00 z1= 2 0.506278978280001E-03 0.000000000000000E+00 z1= 3 -.633255336332148E-07 0.000000000000000E+00 alpha(00000362)=0.000000000000000E+00 beta (00000363)=0.128764386992195E+02 gamma(00000363)=0.128764386992195E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 363 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000363)=0.000000000000000E+00 beta (00000364)=0.140224511699965E+02 gamma(00000364)=0.140224511699965E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 364 z1= 1 0.107667312988996E-06 0.000000000000000E+00 z1= 2 0.971998534469850E-04 0.000000000000000E+00 z1= 3 0.682506642590299E-07 0.000000000000000E+00 alpha(00000364)=0.000000000000000E+00 beta (00000365)=0.129577534464050E+02 gamma(00000365)=0.129577534464050E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 365 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000365)=0.000000000000000E+00 beta (00000366)=0.130222087957777E+02 gamma(00000366)=0.130222087957777E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 366 z1= 1 -.117556805386519E-06 0.000000000000000E+00 z1= 2 -.628255469881262E-03 0.000000000000000E+00 z1= 3 -.784292581751563E-07 0.000000000000000E+00 alpha(00000366)=0.000000000000000E+00 beta (00000367)=0.127367456775651E+02 gamma(00000367)=0.127367456775651E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 367 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000367)=0.000000000000000E+00 beta (00000368)=0.131501717714273E+02 gamma(00000368)=0.131501717714273E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 368 z1= 1 0.126196714530114E-06 0.000000000000000E+00 z1= 2 0.103719190907881E-02 0.000000000000000E+00 z1= 3 0.887239508376219E-07 0.000000000000000E+00 alpha(00000368)=0.000000000000000E+00 beta (00000369)=0.125976928577420E+02 gamma(00000369)=0.125976928577420E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 369 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000369)=0.000000000000000E+00 beta (00000370)=0.141034770114319E+02 gamma(00000370)=0.141034770114319E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 370 z1= 1 -.121665711427343E-06 0.000000000000000E+00 z1= 2 -.128791200906285E-02 0.000000000000000E+00 z1= 3 -.865939802296382E-07 0.000000000000000E+00 alpha(00000370)=0.000000000000000E+00 beta (00000371)=0.125952165738007E+02 gamma(00000371)=0.125952165738007E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 371 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000371)=0.000000000000000E+00 beta (00000372)=0.138035743289612E+02 gamma(00000372)=0.138035743289612E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 372 z1= 1 0.127913802606223E-06 0.000000000000000E+00 z1= 2 0.145080121516386E-02 0.000000000000000E+00 z1= 3 0.920546352660770E-07 0.000000000000000E+00 alpha(00000372)=0.000000000000000E+00 beta (00000373)=0.126539610572256E+02 gamma(00000373)=0.126539610572256E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 373 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000373)=0.000000000000000E+00 beta (00000374)=0.137355530786799E+02 gamma(00000374)=0.137355530786799E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 374 z1= 1 -.128889582864575E-06 0.000000000000000E+00 z1= 2 -.168687065952367E-02 0.000000000000000E+00 z1= 3 -.901714488627100E-07 0.000000000000000E+00 alpha(00000374)=0.000000000000000E+00 beta (00000375)=0.130423467018961E+02 gamma(00000375)=0.130423467018961E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 375 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000375)=0.000000000000000E+00 beta (00000376)=0.134058776778220E+02 gamma(00000376)=0.134058776778220E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 376 z1= 1 0.146396990144664E-06 0.000000000000000E+00 z1= 2 0.201179281978542E-02 0.000000000000000E+00 z1= 3 0.103251127728959E-06 0.000000000000000E+00 alpha(00000376)=0.000000000000000E+00 beta (00000377)=0.122111434614924E+02 gamma(00000377)=0.122111434614924E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 377 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000377)=0.000000000000000E+00 beta (00000378)=0.138772352577489E+02 gamma(00000378)=0.138772352577489E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 378 z1= 1 -.139782562712677E-06 0.000000000000000E+00 z1= 2 -.189826583475139E-02 0.000000000000000E+00 z1= 3 -.941795160556286E-07 0.000000000000000E+00 alpha(00000378)=0.000000000000000E+00 beta (00000379)=0.121585900958820E+02 gamma(00000379)=0.121585900958820E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 379 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000379)=0.000000000000000E+00 beta (00000380)=0.131628118277538E+02 gamma(00000380)=0.131628118277538E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 380 z1= 1 0.155931973280614E-06 0.000000000000000E+00 z1= 2 0.171947845153140E-02 0.000000000000000E+00 z1= 3 0.109007683030300E-06 0.000000000000000E+00 alpha(00000380)=0.000000000000000E+00 beta (00000381)=0.128729500512290E+02 gamma(00000381)=0.128729500512290E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 381 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000381)=0.000000000000000E+00 beta (00000382)=0.136475621240824E+02 gamma(00000382)=0.136475621240824E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 382 z1= 1 -.151450814731241E-06 0.000000000000000E+00 z1= 2 -.137796261770344E-02 0.000000000000000E+00 z1= 3 -.101589069587669E-06 0.000000000000000E+00 alpha(00000382)=0.000000000000000E+00 beta (00000383)=0.136727544067788E+02 gamma(00000383)=0.136727544067788E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 383 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000383)=0.000000000000000E+00 beta (00000384)=0.129441923954896E+02 gamma(00000384)=0.129441923954896E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 384 z1= 1 0.194121588726628E-06 0.000000000000000E+00 z1= 2 0.111398913261731E-02 0.000000000000000E+00 z1= 3 0.138340561372076E-06 0.000000000000000E+00 alpha(00000384)=0.000000000000000E+00 beta (00000385)=0.121422019690762E+02 gamma(00000385)=0.121422019690762E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 385 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000385)=0.000000000000000E+00 beta (00000386)=0.142696976130676E+02 gamma(00000386)=0.142696976130676E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 386 z1= 1 -.160975500316509E-06 0.000000000000000E+00 z1= 2 -.734254418438135E-03 0.000000000000000E+00 z1= 3 -.109038660749930E-06 0.000000000000000E+00 alpha(00000386)=0.000000000000000E+00 beta (00000387)=0.122878855772174E+02 gamma(00000387)=0.122878855772174E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 387 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000387)=0.000000000000000E+00 beta (00000388)=0.137692596253607E+02 gamma(00000388)=0.137692596253607E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 388 z1= 1 0.187535466391947E-06 0.000000000000000E+00 z1= 2 0.520404480473042E-03 0.000000000000000E+00 z1= 3 0.140522124245676E-06 0.000000000000000E+00 alpha(00000388)=0.000000000000000E+00 beta (00000389)=0.130553334560064E+02 gamma(00000389)=0.130553334560064E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 389 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000389)=0.000000000000000E+00 beta (00000390)=0.131675861202496E+02 gamma(00000390)=0.131675861202496E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 390 z1= 1 -.172174308031656E-06 0.000000000000000E+00 z1= 2 -.440065696356972E-03 0.000000000000000E+00 z1= 3 -.116628831996982E-06 0.000000000000000E+00 alpha(00000390)=0.000000000000000E+00 beta (00000391)=0.127253585556022E+02 gamma(00000391)=0.127253585556022E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 391 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000391)=0.000000000000000E+00 beta (00000392)=0.130369674781196E+02 gamma(00000392)=0.130369674781196E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 392 z1= 1 0.234474530797901E-06 0.000000000000000E+00 z1= 2 0.442594109481956E-03 0.000000000000000E+00 z1= 3 0.176846645569577E-06 0.000000000000000E+00 alpha(00000392)=0.000000000000000E+00 beta (00000393)=0.130668027686218E+02 gamma(00000393)=0.130668027686218E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 393 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000393)=0.000000000000000E+00 beta (00000394)=0.136509834001852E+02 gamma(00000394)=0.136509834001852E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 394 z1= 1 -.183780315876538E-06 0.000000000000000E+00 z1= 2 -.443647585687060E-03 0.000000000000000E+00 z1= 3 -.118629927307705E-06 0.000000000000000E+00 alpha(00000394)=0.000000000000000E+00 beta (00000395)=0.120093720561808E+02 gamma(00000395)=0.120093720561808E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 395 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000395)=0.000000000000000E+00 beta (00000396)=0.140101020691916E+02 gamma(00000396)=0.140101020691916E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 396 z1= 1 0.257665201324614E-06 0.000000000000000E+00 z1= 2 0.287722785387960E-03 0.000000000000000E+00 z1= 3 0.201498171128122E-06 0.000000000000000E+00 alpha(00000396)=0.000000000000000E+00 beta (00000397)=0.130586914635588E+02 gamma(00000397)=0.130586914635588E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 397 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000397)=0.000000000000000E+00 beta (00000398)=0.143622139254529E+02 gamma(00000398)=0.143622139254529E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 398 z1= 1 -.157657843160349E-06 0.000000000000000E+00 z1= 2 -.596064068110955E-04 0.000000000000000E+00 z1= 3 -.856811213108927E-07 0.000000000000000E+00 alpha(00000398)=0.000000000000000E+00 beta (00000399)=0.120142420078463E+02 gamma(00000399)=0.120142420078463E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 399 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000399)=0.000000000000000E+00 beta (00000400)=0.133492861346165E+02 gamma(00000400)=0.133492861346165E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 400 z1= 1 0.285759716590244E-06 0.000000000000000E+00 z1= 2 -.209202687522416E-03 0.000000000000000E+00 z1= 3 0.221798572640154E-06 0.000000000000000E+00 alpha(00000400)=0.000000000000000E+00 beta (00000401)=0.130144673259499E+02 gamma(00000401)=0.130144673259499E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 401 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000401)=0.000000000000000E+00 beta (00000402)=0.133954708810395E+02 gamma(00000402)=0.133954708810395E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 402 z1= 1 -.159479823980254E-06 0.000000000000000E+00 z1= 2 0.340510989159682E-03 0.000000000000000E+00 z1= 3 -.722948889994449E-07 0.000000000000000E+00 alpha(00000402)=0.000000000000000E+00 beta (00000403)=0.129783774895056E+02 gamma(00000403)=0.129783774895056E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 403 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000403)=0.000000000000000E+00 beta (00000404)=0.139900994133720E+02 gamma(00000404)=0.139900994133720E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 404 z1= 1 0.344046546367667E-06 0.000000000000000E+00 z1= 2 -.418005134974355E-03 0.000000000000000E+00 z1= 3 0.272893040990712E-06 0.000000000000000E+00 alpha(00000404)=0.000000000000000E+00 beta (00000405)=0.135323359096084E+02 gamma(00000405)=0.135323359096084E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 405 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000405)=0.000000000000000E+00 beta (00000406)=0.135455772443944E+02 gamma(00000406)=0.135455772443944E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 406 z1= 1 -.185785640661670E-06 0.000000000000000E+00 z1= 2 0.546418683332536E-03 0.000000000000000E+00 z1= 3 -.867769474649678E-07 0.000000000000000E+00 alpha(00000406)=0.000000000000000E+00 beta (00000407)=0.130213743177949E+02 gamma(00000407)=0.130213743177949E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 407 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000407)=0.000000000000000E+00 beta (00000408)=0.138747306767892E+02 gamma(00000408)=0.138747306767892E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 408 z1= 1 0.353793942305808E-06 0.000000000000000E+00 z1= 2 -.633144846565424E-03 0.000000000000000E+00 z1= 3 0.270267461778551E-06 0.000000000000000E+00 alpha(00000408)=0.000000000000000E+00 beta (00000409)=0.127665804794412E+02 gamma(00000409)=0.127665804794412E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 409 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000409)=0.000000000000000E+00 beta (00000410)=0.127429878139796E+02 gamma(00000410)=0.127429878139796E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 410 z1= 1 -.253998548748434E-06 0.000000000000000E+00 z1= 2 0.781059470496854E-03 0.000000000000000E+00 z1= 3 -.147533145708175E-06 0.000000000000000E+00 alpha(00000410)=0.000000000000000E+00 beta (00000411)=0.129587052133457E+02 gamma(00000411)=0.129587052133457E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 411 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000411)=0.000000000000000E+00 beta (00000412)=0.139837453408433E+02 gamma(00000412)=0.139837453408433E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 412 z1= 1 0.360809105348289E-06 0.000000000000000E+00 z1= 2 -.813993301488942E-03 0.000000000000000E+00 z1= 3 0.268871939153575E-06 0.000000000000000E+00 alpha(00000412)=0.000000000000000E+00 beta (00000413)=0.123337333268104E+02 gamma(00000413)=0.123337333268104E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 413 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000413)=0.000000000000000E+00 beta (00000414)=0.136951585394312E+02 gamma(00000414)=0.136951585394312E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 414 z1= 1 -.261113562665012E-06 0.000000000000000E+00 z1= 2 0.759630277243848E-03 0.000000000000000E+00 z1= 3 -.161076796566218E-06 0.000000000000000E+00 alpha(00000414)=0.000000000000000E+00 beta (00000415)=0.130446037588232E+02 gamma(00000415)=0.130446037588232E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 415 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000415)=0.000000000000000E+00 beta (00000416)=0.132127829352448E+02 gamma(00000416)=0.132127829352448E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 416 z1= 1 0.366569499997632E-06 0.000000000000000E+00 z1= 2 -.688038636887952E-03 0.000000000000000E+00 z1= 3 0.277657502950764E-06 0.000000000000000E+00 alpha(00000416)=0.000000000000000E+00 beta (00000417)=0.123149604399109E+02 gamma(00000417)=0.123149604399109E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 417 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000417)=0.000000000000000E+00 beta (00000418)=0.133362583583047E+02 gamma(00000418)=0.133362583583047E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 418 z1= 1 -.282686247687469E-06 0.000000000000000E+00 z1= 2 0.412465331457705E-03 0.000000000000000E+00 z1= 3 -.185483476184529E-06 0.000000000000000E+00 alpha(00000418)=0.000000000000000E+00 beta (00000419)=0.137070487232495E+02 gamma(00000419)=0.137070487232495E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 419 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000419)=0.000000000000000E+00 beta (00000420)=0.141219781047076E+02 gamma(00000420)=0.141219781047076E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 420 z1= 1 0.382114635136613E-06 0.000000000000000E+00 z1= 2 -.943604494824946E-04 0.000000000000000E+00 z1= 3 0.301923643865408E-06 0.000000000000000E+00 alpha(00000420)=0.000000000000000E+00 beta (00000421)=0.126255874665392E+02 gamma(00000421)=0.126255874665392E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 421 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000421)=0.000000000000000E+00 beta (00000422)=0.142699471997680E+02 gamma(00000422)=0.142699471997680E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 422 z1= 1 -.288973796505436E-06 0.000000000000000E+00 z1= 2 -.262285362878205E-03 0.000000000000000E+00 z1= 3 -.203168996675701E-06 0.000000000000000E+00 alpha(00000422)=0.000000000000000E+00 beta (00000423)=0.122814456126318E+02 gamma(00000423)=0.122814456126318E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 423 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000423)=0.000000000000000E+00 beta (00000424)=0.130718386553627E+02 gamma(00000424)=0.130718386553627E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 424 z1= 1 0.355025322773019E-06 0.000000000000000E+00 z1= 2 0.597064910981240E-03 0.000000000000000E+00 z1= 3 0.289038158167459E-06 0.000000000000000E+00 alpha(00000424)=0.000000000000000E+00 beta (00000425)=0.127503758774952E+02 gamma(00000425)=0.127503758774952E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 425 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000425)=0.000000000000000E+00 beta (00000426)=0.141446435702841E+02 gamma(00000426)=0.141446435702841E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 426 z1= 1 -.301471056948083E-06 0.000000000000000E+00 z1= 2 -.827708194524279E-03 0.000000000000000E+00 z1= 3 -.228519048560384E-06 0.000000000000000E+00 alpha(00000426)=0.000000000000000E+00 beta (00000427)=0.126266668382499E+02 gamma(00000427)=0.126266668382499E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 427 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000427)=0.000000000000000E+00 beta (00000428)=0.140015620024189E+02 gamma(00000428)=0.140015620024189E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 428 z1= 1 0.337117167465827E-06 0.000000000000000E+00 z1= 2 0.105065844023186E-02 0.000000000000000E+00 z1= 3 0.277723055703010E-06 0.000000000000000E+00 alpha(00000428)=0.000000000000000E+00 beta (00000429)=0.120366194887365E+02 gamma(00000429)=0.120366194887365E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 429 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000429)=0.000000000000000E+00 beta (00000430)=0.131948063045592E+02 gamma(00000430)=0.131948063045592E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 430 z1= 1 -.317353528825250E-06 0.000000000000000E+00 z1= 2 -.132159093143461E-02 0.000000000000000E+00 z1= 3 -.245148793343269E-06 0.000000000000000E+00 alpha(00000430)=0.000000000000000E+00 beta (00000431)=0.124908549870189E+02 gamma(00000431)=0.124908549870189E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 431 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000431)=0.000000000000000E+00 beta (00000432)=0.135089308226951E+02 gamma(00000432)=0.135089308226951E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 432 z1= 1 0.350661275355310E-06 0.000000000000000E+00 z1= 2 0.160767975491630E-02 0.000000000000000E+00 z1= 3 0.293612251187728E-06 0.000000000000000E+00 alpha(00000432)=0.000000000000000E+00 beta (00000433)=0.127847731958389E+02 gamma(00000433)=0.127847731958389E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 433 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000433)=0.000000000000000E+00 beta (00000434)=0.142332603167768E+02 gamma(00000434)=0.142332603167768E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 434 z1= 1 -.323921976021560E-06 0.000000000000000E+00 z1= 2 -.170970360170661E-02 0.000000000000000E+00 z1= 3 -.257349171663135E-06 0.000000000000000E+00 alpha(00000434)=0.000000000000000E+00 beta (00000435)=0.119609110669647E+02 gamma(00000435)=0.119609110669647E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 435 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000435)=0.000000000000000E+00 beta (00000436)=0.132313753698552E+02 gamma(00000436)=0.132313753698552E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 436 z1= 1 0.355893154723634E-06 0.000000000000000E+00 z1= 2 0.170275286291064E-02 0.000000000000000E+00 z1= 3 0.314440341902871E-06 0.000000000000000E+00 alpha(00000436)=0.000000000000000E+00 beta (00000437)=0.124348178093229E+02 gamma(00000437)=0.124348178093229E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 437 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000437)=0.000000000000000E+00 beta (00000438)=0.141048941887408E+02 gamma(00000438)=0.141048941887408E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 438 z1= 1 -.324968116913356E-06 0.000000000000000E+00 z1= 2 -.144101942081888E-02 0.000000000000000E+00 z1= 3 -.258741032234432E-06 0.000000000000000E+00 alpha(00000438)=0.000000000000000E+00 beta (00000439)=0.136983269103188E+02 gamma(00000439)=0.136983269103188E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 439 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000439)=0.000000000000000E+00 beta (00000440)=0.136782539453079E+02 gamma(00000440)=0.136782539453079E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 440 z1= 1 0.399852536479232E-06 0.000000000000000E+00 z1= 2 0.118580392134201E-02 0.000000000000000E+00 z1= 3 0.362269726649064E-06 0.000000000000000E+00 alpha(00000440)=0.000000000000000E+00 beta (00000441)=0.133736685884745E+02 gamma(00000441)=0.133736685884745E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 441 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000441)=0.000000000000000E+00 beta (00000442)=0.135066920113631E+02 gamma(00000442)=0.135066920113631E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 442 z1= 1 -.408485150246935E-06 0.000000000000000E+00 z1= 2 -.780293748030273E-03 0.000000000000000E+00 z1= 3 -.337509878438509E-06 0.000000000000000E+00 alpha(00000442)=0.000000000000000E+00 beta (00000443)=0.123798705779465E+02 gamma(00000443)=0.123798705779465E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 443 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000443)=0.000000000000000E+00 beta (00000444)=0.136658787823491E+02 gamma(00000444)=0.136658787823491E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 444 z1= 1 0.433405627752077E-06 0.000000000000000E+00 z1= 2 0.232533869010180E-03 0.000000000000000E+00 z1= 3 0.390148843461280E-06 0.000000000000000E+00 alpha(00000444)=0.000000000000000E+00 beta (00000445)=0.133177139379766E+02 gamma(00000445)=0.133177139379766E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 445 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000445)=0.000000000000000E+00 beta (00000446)=0.134276923481421E+02 gamma(00000446)=0.134276923481421E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 446 z1= 1 -.454742533705522E-06 0.000000000000000E+00 z1= 2 0.260120127276736E-03 0.000000000000000E+00 z1= 3 -.388892514281052E-06 0.000000000000000E+00 alpha(00000446)=0.000000000000000E+00 beta (00000447)=0.130302090104868E+02 gamma(00000447)=0.130302090104868E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 447 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000447)=0.000000000000000E+00 beta (00000448)=0.131686462906148E+02 gamma(00000448)=0.131686462906148E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 448 z1= 1 0.505656498978047E-06 0.000000000000000E+00 z1= 2 -.784658436648753E-03 0.000000000000000E+00 z1= 3 0.449497664927086E-06 0.000000000000000E+00 alpha(00000448)=0.000000000000000E+00 beta (00000449)=0.126248058940015E+02 gamma(00000449)=0.126248058940015E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 449 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000449)=0.000000000000000E+00 beta (00000450)=0.125958494252162E+02 gamma(00000450)=0.125958494252162E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 450 z1= 1 -.545406000022897E-06 0.000000000000000E+00 z1= 2 0.139211658010383E-02 0.000000000000000E+00 z1= 3 -.475873791413355E-06 0.000000000000000E+00 alpha(00000450)=0.000000000000000E+00 beta (00000451)=0.128860470635185E+02 gamma(00000451)=0.128860470635185E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 451 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000451)=0.000000000000000E+00 beta (00000452)=0.132417944883717E+02 gamma(00000452)=0.132417944883717E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 452 z1= 1 0.578530742503976E-06 0.000000000000000E+00 z1= 2 -.204046857262458E-02 0.000000000000000E+00 z1= 3 0.507734652302819E-06 0.000000000000000E+00 alpha(00000452)=0.000000000000000E+00 beta (00000453)=0.119875870362537E+02 gamma(00000453)=0.119875870362537E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 453 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000453)=0.000000000000000E+00 beta (00000454)=0.142317998585658E+02 gamma(00000454)=0.142317998585658E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 454 z1= 1 -.523768877237589E-06 0.000000000000000E+00 z1= 2 0.240852032562596E-02 0.000000000000000E+00 z1= 3 -.457928244700003E-06 0.000000000000000E+00 alpha(00000454)=0.000000000000000E+00 beta (00000455)=0.124166616123045E+02 gamma(00000455)=0.124166616123045E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 455 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000455)=0.000000000000000E+00 beta (00000456)=0.140317937497027E+02 gamma(00000456)=0.140317937497027E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 456 z1= 1 0.512458209419447E-06 0.000000000000000E+00 z1= 2 -.271193866959288E-02 0.000000000000000E+00 z1= 3 0.449039594542077E-06 0.000000000000000E+00 alpha(00000456)=0.000000000000000E+00 beta (00000457)=0.121747277525390E+02 gamma(00000457)=0.121747277525390E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 457 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000457)=0.000000000000000E+00 beta (00000458)=0.136300565237593E+02 gamma(00000458)=0.136300565237593E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 458 z1= 1 -.500232682878674E-06 0.000000000000000E+00 z1= 2 0.290716436265412E-02 0.000000000000000E+00 z1= 3 -.448244824756286E-06 0.000000000000000E+00 alpha(00000458)=0.000000000000000E+00 beta (00000459)=0.129297809836113E+02 gamma(00000459)=0.129297809836113E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 459 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000459)=0.000000000000000E+00 beta (00000460)=0.138331648164365E+02 gamma(00000460)=0.138331648164365E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 460 z1= 1 0.523368717246508E-06 0.000000000000000E+00 z1= 2 -.299056182714515E-02 0.000000000000000E+00 z1= 3 0.468503709366965E-06 0.000000000000000E+00 alpha(00000460)=0.000000000000000E+00 beta (00000461)=0.131800069906600E+02 gamma(00000461)=0.131800069906600E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 461 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000461)=0.000000000000000E+00 beta (00000462)=0.133040063674614E+02 gamma(00000462)=0.133040063674614E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 462 z1= 1 -.559576492179317E-06 0.000000000000000E+00 z1= 2 0.321669340213195E-02 0.000000000000000E+00 z1= 3 -.517064708819908E-06 0.000000000000000E+00 alpha(00000462)=0.000000000000000E+00 beta (00000463)=0.120924479912125E+02 gamma(00000463)=0.120924479912125E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 463 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000463)=0.000000000000000E+00 beta (00000464)=0.130735632851036E+02 gamma(00000464)=0.130735632851036E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 464 z1= 1 0.585738423729710E-06 0.000000000000000E+00 z1= 2 -.330626163729302E-02 0.000000000000000E+00 z1= 3 0.535582145009574E-06 0.000000000000000E+00 alpha(00000464)=0.000000000000000E+00 beta (00000465)=0.126609150449414E+02 gamma(00000465)=0.126609150449414E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 465 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000465)=0.000000000000000E+00 beta (00000466)=0.139043910091926E+02 gamma(00000466)=0.139043910091926E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 466 z1= 1 -.564949439084850E-06 0.000000000000000E+00 z1= 2 0.327275682949741E-02 0.000000000000000E+00 z1= 3 -.539413248424551E-06 0.000000000000000E+00 alpha(00000466)=0.000000000000000E+00 beta (00000467)=0.125791890153128E+02 gamma(00000467)=0.125791890153128E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 467 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000467)=0.000000000000000E+00 beta (00000468)=0.133095191303252E+02 gamma(00000468)=0.133095191303252E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 468 z1= 1 0.618614049479205E-06 0.000000000000000E+00 z1= 2 -.325039330317410E-02 0.000000000000000E+00 z1= 3 0.577717435542376E-06 0.000000000000000E+00 alpha(00000468)=0.000000000000000E+00 beta (00000469)=0.132921250874501E+02 gamma(00000469)=0.132921250874501E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 469 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000469)=0.000000000000000E+00 beta (00000470)=0.142441314013405E+02 gamma(00000470)=0.142441314013405E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 470 z1= 1 -.587195136429828E-06 0.000000000000000E+00 z1= 2 0.310828710142314E-02 0.000000000000000E+00 z1= 3 -.583984841520690E-06 0.000000000000000E+00 alpha(00000470)=0.000000000000000E+00 beta (00000471)=0.124870229298197E+02 gamma(00000471)=0.124870229298197E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 471 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000471)=0.000000000000000E+00 beta (00000472)=0.134864504257885E+02 gamma(00000472)=0.134864504257885E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 472 z1= 1 0.651064497654130E-06 0.000000000000000E+00 z1= 2 -.297793946053116E-02 0.000000000000000E+00 z1= 3 0.623217656891748E-06 0.000000000000000E+00 alpha(00000472)=0.000000000000000E+00 beta (00000473)=0.124010339502217E+02 gamma(00000473)=0.124010339502217E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 473 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000473)=0.000000000000000E+00 beta (00000474)=0.138025368624468E+02 gamma(00000474)=0.138025368624468E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 474 z1= 1 -.582344396194562E-06 0.000000000000000E+00 z1= 2 0.285580780850203E-02 0.000000000000000E+00 z1= 3 -.597561334171929E-06 0.000000000000000E+00 alpha(00000474)=0.000000000000000E+00 beta (00000475)=0.127787814476644E+02 gamma(00000475)=0.127787814476644E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 475 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000475)=0.000000000000000E+00 beta (00000476)=0.132117612509455E+02 gamma(00000476)=0.132117612509455E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 476 z1= 1 0.717663201643248E-06 0.000000000000000E+00 z1= 2 -.300946055162484E-02 0.000000000000000E+00 z1= 3 0.696704722151845E-06 0.000000000000000E+00 alpha(00000476)=0.000000000000000E+00 beta (00000477)=0.130725234674338E+02 gamma(00000477)=0.130725234674338E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 477 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000477)=0.000000000000000E+00 beta (00000478)=0.147836129115432E+02 gamma(00000478)=0.147836129115432E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 478 z1= 1 -.587441444784183E-06 0.000000000000000E+00 z1= 2 0.292567435385048E-02 0.000000000000000E+00 z1= 3 -.614996956910003E-06 0.000000000000000E+00 alpha(00000478)=0.000000000000000E+00 beta (00000479)=0.127496358763402E+02 gamma(00000479)=0.127496358763402E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 479 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000479)=0.000000000000000E+00 beta (00000480)=0.136063534416750E+02 gamma(00000480)=0.136063534416750E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 480 z1= 1 0.738919002602010E-06 0.000000000000000E+00 z1= 2 -.303422460259764E-02 0.000000000000000E+00 z1= 3 0.731356470523581E-06 0.000000000000000E+00 alpha(00000480)=0.000000000000000E+00 beta (00000481)=0.126115353983326E+02 gamma(00000481)=0.126115353983326E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 481 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000481)=0.000000000000000E+00 beta (00000482)=0.136788867285234E+02 gamma(00000482)=0.136788867285234E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 482 z1= 1 -.638925251122101E-06 0.000000000000000E+00 z1= 2 0.302297290053542E-02 0.000000000000000E+00 z1= 3 -.668578676217189E-06 0.000000000000000E+00 alpha(00000482)=0.000000000000000E+00 beta (00000483)=0.126573714625602E+02 gamma(00000483)=0.126573714625602E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 483 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000483)=0.000000000000000E+00 beta (00000484)=0.138661225272056E+02 gamma(00000484)=0.138661225272056E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 484 z1= 1 0.781918333260393E-06 0.000000000000000E+00 z1= 2 -.301877782974754E-02 0.000000000000000E+00 z1= 3 0.800125544389032E-06 0.000000000000000E+00 alpha(00000484)=0.000000000000000E+00 beta (00000485)=0.129992315194941E+02 gamma(00000485)=0.129992315194941E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 485 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000485)=0.000000000000000E+00 beta (00000486)=0.135297036907626E+02 gamma(00000486)=0.135297036907626E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 486 z1= 1 -.698550164078722E-06 0.000000000000000E+00 z1= 2 0.316797183973046E-02 0.000000000000000E+00 z1= 3 -.733793505926217E-06 0.000000000000000E+00 alpha(00000486)=0.000000000000000E+00 beta (00000487)=0.125562118151652E+02 gamma(00000487)=0.125562118151652E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 487 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000487)=0.000000000000000E+00 beta (00000488)=0.132628507116992E+02 gamma(00000488)=0.132628507116992E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 488 z1= 1 0.892395037541474E-06 0.000000000000000E+00 z1= 2 -.328083125440916E-02 0.000000000000000E+00 z1= 3 0.939103416657439E-06 0.000000000000000E+00 alpha(00000488)=0.000000000000000E+00 beta (00000489)=0.128916746832402E+02 gamma(00000489)=0.128916746832402E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 489 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000489)=0.000000000000000E+00 beta (00000490)=0.138935030112391E+02 gamma(00000490)=0.138935030112391E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 490 z1= 1 -.741402440050751E-06 0.000000000000000E+00 z1= 2 0.332186083739100E-02 0.000000000000000E+00 z1= 3 -.777776300972598E-06 0.000000000000000E+00 alpha(00000490)=0.000000000000000E+00 beta (00000491)=0.132498472916494E+02 gamma(00000491)=0.132498472916494E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 491 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000491)=0.000000000000000E+00 beta (00000492)=0.131835001428570E+02 gamma(00000492)=0.131835001428570E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 492 z1= 1 0.102987485367479E-05 0.000000000000000E+00 z1= 2 -.360113411497137E-02 0.000000000000000E+00 z1= 3 0.110461522149369E-05 0.000000000000000E+00 alpha(00000492)=0.000000000000000E+00 beta (00000493)=0.123692639822574E+02 gamma(00000493)=0.123692639822574E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 493 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000493)=0.000000000000000E+00 beta (00000494)=0.144476215280531E+02 gamma(00000494)=0.144476215280531E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 494 z1= 1 -.760835437782579E-06 0.000000000000000E+00 z1= 2 0.331432717739699E-02 0.000000000000000E+00 z1= 3 -.796750949440988E-06 0.000000000000000E+00 alpha(00000494)=0.000000000000000E+00 beta (00000495)=0.121863616314208E+02 gamma(00000495)=0.121863616314208E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 495 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000495)=0.000000000000000E+00 beta (00000496)=0.142341931194024E+02 gamma(00000496)=0.142341931194024E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 496 z1= 1 0.977333147824961E-06 0.000000000000000E+00 z1= 2 -.303842209526815E-02 0.000000000000000E+00 z1= 3 0.106972222994566E-05 0.000000000000000E+00 alpha(00000496)=0.000000000000000E+00 beta (00000497)=0.127258478796272E+02 gamma(00000497)=0.127258478796272E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 497 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000497)=0.000000000000000E+00 beta (00000498)=0.139469100465666E+02 gamma(00000498)=0.139469100465666E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 498 z1= 1 -.749959323005124E-06 0.000000000000000E+00 z1= 2 0.289628788218616E-02 0.000000000000000E+00 z1= 3 -.790040187166309E-06 0.000000000000000E+00 alpha(00000498)=0.000000000000000E+00 beta (00000499)=0.122914337246679E+02 gamma(00000499)=0.122914337246679E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 499 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000499)=0.000000000000000E+00 beta (00000500)=0.137516138281383E+02 gamma(00000500)=0.137516138281383E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 500 z1= 1 0.104076610940107E-05 0.000000000000000E+00 z1= 2 -.274731333564418E-02 0.000000000000000E+00 z1= 3 0.116217281441669E-05 0.000000000000000E+00 alpha(00000500)=0.000000000000000E+00 beta (00000501)=0.129016897333019E+02 gamma(00000501)=0.129016897333019E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Norm of initial Lanczos vectors= 0.939778394570208 Starting Lanczos loop 3 Lanczos iteration: 1 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal alpha(00000001)=0.000000000000000E+00 beta (00000002)=0.202673004745739E+01 gamma(00000002)=0.202673004745739E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 2 z1= 1 -.163965587049626E-07 0.000000000000000E+00 z1= 2 -.190054843928616E-07 0.000000000000000E+00 z1= 3 0.629150408756227E+00 0.000000000000000E+00 alpha(00000002)=0.000000000000000E+00 beta (00000003)=0.676214285896413E+01 gamma(00000003)=0.676214285896413E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 3 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000003)=0.000000000000000E+00 beta (00000004)=0.144232715158780E+02 gamma(00000004)=0.144232715158780E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 4 z1= 1 0.270082192504670E-09 0.000000000000000E+00 z1= 2 0.535810309033706E-08 0.000000000000000E+00 z1= 3 -.235142088521153E+00 0.000000000000000E+00 alpha(00000004)=0.000000000000000E+00 beta (00000005)=0.123530686904081E+02 gamma(00000005)=0.123530686904081E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 5 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000005)=0.000000000000000E+00 beta (00000006)=0.140729509417416E+02 gamma(00000006)=0.140729509417416E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 6 z1= 1 0.437363897990459E-07 0.000000000000000E+00 z1= 2 -.968159286182831E-08 0.000000000000000E+00 z1= 3 0.183518350572070E+00 0.000000000000000E+00 alpha(00000006)=0.000000000000000E+00 beta (00000007)=0.125639480063935E+02 gamma(00000007)=0.125639480063935E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 7 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000007)=0.000000000000000E+00 beta (00000008)=0.137603612542804E+02 gamma(00000008)=0.137603612542804E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 8 z1= 1 -.606234064306403E-07 0.000000000000000E+00 z1= 2 0.121485237663914E-07 0.000000000000000E+00 z1= 3 -.154636002660510E+00 0.000000000000000E+00 alpha(00000008)=0.000000000000000E+00 beta (00000009)=0.127447803678870E+02 gamma(00000009)=0.127447803678870E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 9 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000009)=0.000000000000000E+00 beta (00000010)=0.137234353636475E+02 gamma(00000010)=0.137234353636475E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 10 z1= 1 0.459385627899368E-07 0.000000000000000E+00 z1= 2 -.151505258239211E-07 0.000000000000000E+00 z1= 3 0.135281263809339E+00 0.000000000000000E+00 alpha(00000010)=0.000000000000000E+00 beta (00000011)=0.128469548074082E+02 gamma(00000011)=0.128469548074082E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 11 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000011)=0.000000000000000E+00 beta (00000012)=0.137259793544290E+02 gamma(00000012)=0.137259793544290E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 12 z1= 1 -.181099658549564E-07 0.000000000000000E+00 z1= 2 0.187245206108907E-07 0.000000000000000E+00 z1= 3 -.120560915814004E+00 0.000000000000000E+00 alpha(00000012)=0.000000000000000E+00 beta (00000013)=0.128257493452321E+02 gamma(00000013)=0.128257493452321E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 13 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000013)=0.000000000000000E+00 beta (00000014)=0.137037723109482E+02 gamma(00000014)=0.137037723109482E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 14 z1= 1 -.190504032409082E-07 0.000000000000000E+00 z1= 2 -.226022417088891E-07 0.000000000000000E+00 z1= 3 0.108228057101801E+00 0.000000000000000E+00 alpha(00000014)=0.000000000000000E+00 beta (00000015)=0.128910520077736E+02 gamma(00000015)=0.128910520077736E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 15 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000015)=0.000000000000000E+00 beta (00000016)=0.137488972353440E+02 gamma(00000016)=0.137488972353440E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 16 z1= 1 0.551578229178191E-07 0.000000000000000E+00 z1= 2 0.258365414956482E-07 0.000000000000000E+00 z1= 3 -.978708869436065E-01 0.000000000000000E+00 alpha(00000016)=0.000000000000000E+00 beta (00000017)=0.128678066497233E+02 gamma(00000017)=0.128678066497233E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 17 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000017)=0.000000000000000E+00 beta (00000018)=0.135655622464679E+02 gamma(00000018)=0.135655622464679E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 18 z1= 1 -.913049331380082E-07 0.000000000000000E+00 z1= 2 -.287616328212715E-07 0.000000000000000E+00 z1= 3 0.898837785814772E-01 0.000000000000000E+00 alpha(00000018)=0.000000000000000E+00 beta (00000019)=0.127873619034795E+02 gamma(00000019)=0.127873619034795E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 19 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000019)=0.000000000000000E+00 beta (00000020)=0.135613713621220E+02 gamma(00000020)=0.135613713621220E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 20 z1= 1 0.115703490985919E-06 0.000000000000000E+00 z1= 2 0.309374385679996E-07 0.000000000000000E+00 z1= 3 -.823803957268194E-01 0.000000000000000E+00 alpha(00000020)=0.000000000000000E+00 beta (00000021)=0.128376432281458E+02 gamma(00000021)=0.128376432281458E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 21 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000021)=0.000000000000000E+00 beta (00000022)=0.136499918958347E+02 gamma(00000022)=0.136499918958347E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 22 z1= 1 -.127185021942693E-06 0.000000000000000E+00 z1= 2 -.324247001017627E-07 0.000000000000000E+00 z1= 3 0.755596449014986E-01 0.000000000000000E+00 alpha(00000022)=0.000000000000000E+00 beta (00000023)=0.129827344958965E+02 gamma(00000023)=0.129827344958965E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 23 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000023)=0.000000000000000E+00 beta (00000024)=0.134495826830101E+02 gamma(00000024)=0.134495826830101E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 24 z1= 1 0.130693717877617E-06 0.000000000000000E+00 z1= 2 0.347058024448028E-07 0.000000000000000E+00 z1= 3 -.713477192618220E-01 0.000000000000000E+00 alpha(00000024)=0.000000000000000E+00 beta (00000025)=0.126681676648341E+02 gamma(00000025)=0.126681676648341E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 25 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000025)=0.000000000000000E+00 beta (00000026)=0.137615936058764E+02 gamma(00000026)=0.137615936058764E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 26 z1= 1 -.118433424397949E-06 0.000000000000000E+00 z1= 2 -.349098974619481E-07 0.000000000000000E+00 z1= 3 0.644237366802647E-01 0.000000000000000E+00 alpha(00000026)=0.000000000000000E+00 beta (00000027)=0.130623624637206E+02 gamma(00000027)=0.130623624637206E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 27 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000027)=0.000000000000000E+00 beta (00000028)=0.135141711864150E+02 gamma(00000028)=0.135141711864150E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 28 z1= 1 0.111024745420136E-06 0.000000000000000E+00 z1= 2 0.365668744021531E-07 0.000000000000000E+00 z1= 3 -.612012743331906E-01 0.000000000000000E+00 alpha(00000028)=0.000000000000000E+00 beta (00000029)=0.130061876191909E+02 gamma(00000029)=0.130061876191909E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 29 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000029)=0.000000000000000E+00 beta (00000030)=0.137121933605549E+02 gamma(00000030)=0.137121933605549E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 30 z1= 1 -.107161690807503E-06 0.000000000000000E+00 z1= 2 -.372846598486846E-07 0.000000000000000E+00 z1= 3 0.571692163113523E-01 0.000000000000000E+00 alpha(00000030)=0.000000000000000E+00 beta (00000031)=0.128582599937396E+02 gamma(00000031)=0.128582599937396E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 31 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000031)=0.000000000000000E+00 beta (00000032)=0.136045203195622E+02 gamma(00000032)=0.136045203195622E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 32 z1= 1 0.112948990214565E-06 0.000000000000000E+00 z1= 2 0.375574174143502E-07 0.000000000000000E+00 z1= 3 -.532957289144703E-01 0.000000000000000E+00 alpha(00000032)=0.000000000000000E+00 beta (00000033)=0.128128172595707E+02 gamma(00000033)=0.128128172595707E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 33 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000033)=0.000000000000000E+00 beta (00000034)=0.137299926283152E+02 gamma(00000034)=0.137299926283152E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 34 z1= 1 -.124582883393246E-06 0.000000000000000E+00 z1= 2 -.371057278045900E-07 0.000000000000000E+00 z1= 3 0.490958697492875E-01 0.000000000000000E+00 alpha(00000034)=0.000000000000000E+00 beta (00000035)=0.126998692523938E+02 gamma(00000035)=0.126998692523938E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 35 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000035)=0.000000000000000E+00 beta (00000036)=0.133734186571339E+02 gamma(00000036)=0.133734186571339E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 36 z1= 1 0.152294032946870E-06 0.000000000000000E+00 z1= 2 0.371418122655301E-07 0.000000000000000E+00 z1= 3 -.459820969229689E-01 0.000000000000000E+00 alpha(00000036)=0.000000000000000E+00 beta (00000037)=0.129695288104298E+02 gamma(00000037)=0.129695288104298E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 37 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000037)=0.000000000000000E+00 beta (00000038)=0.134594520665130E+02 gamma(00000038)=0.134594520665130E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 38 z1= 1 -.190605543108884E-06 0.000000000000000E+00 z1= 2 -.382048184863377E-07 0.000000000000000E+00 z1= 3 0.437562705901210E-01 0.000000000000000E+00 alpha(00000038)=0.000000000000000E+00 beta (00000039)=0.129374607523253E+02 gamma(00000039)=0.129374607523253E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 39 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000039)=0.000000000000000E+00 beta (00000040)=0.134403556971672E+02 gamma(00000040)=0.134403556971672E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 40 z1= 1 0.231269795466626E-06 0.000000000000000E+00 z1= 2 0.393929545942830E-07 0.000000000000000E+00 z1= 3 -.416197462240088E-01 0.000000000000000E+00 alpha(00000040)=0.000000000000000E+00 beta (00000041)=0.128080730443206E+02 gamma(00000041)=0.128080730443206E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 41 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000041)=0.000000000000000E+00 beta (00000042)=0.136926850542996E+02 gamma(00000042)=0.136926850542996E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 42 z1= 1 -.268467414700035E-06 0.000000000000000E+00 z1= 2 -.389841561693758E-07 0.000000000000000E+00 z1= 3 0.384617668668042E-01 0.000000000000000E+00 alpha(00000042)=0.000000000000000E+00 beta (00000043)=0.127889286779032E+02 gamma(00000043)=0.127889286779032E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 43 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000043)=0.000000000000000E+00 beta (00000044)=0.136041838687028E+02 gamma(00000044)=0.136041838687028E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 44 z1= 1 0.301970791071089E-06 0.000000000000000E+00 z1= 2 0.394783839539415E-07 0.000000000000000E+00 z1= 3 -.357055199367836E-01 0.000000000000000E+00 alpha(00000044)=0.000000000000000E+00 beta (00000045)=0.125338652427530E+02 gamma(00000045)=0.125338652427530E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 45 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000045)=0.000000000000000E+00 beta (00000046)=0.133781099149332E+02 gamma(00000046)=0.133781099149332E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 46 z1= 1 -.329865069405300E-06 0.000000000000000E+00 z1= 2 -.409579247648804E-07 0.000000000000000E+00 z1= 3 0.329952399503345E-01 0.000000000000000E+00 alpha(00000046)=0.000000000000000E+00 beta (00000047)=0.124795001608591E+02 gamma(00000047)=0.124795001608591E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 47 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000047)=0.000000000000000E+00 beta (00000048)=0.135947228073794E+02 gamma(00000048)=0.135947228073794E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 48 z1= 1 0.343782218340969E-06 0.000000000000000E+00 z1= 2 0.424358997451295E-07 0.000000000000000E+00 z1= 3 -.297955205727565E-01 0.000000000000000E+00 alpha(00000048)=0.000000000000000E+00 beta (00000049)=0.131024581385095E+02 gamma(00000049)=0.131024581385095E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 49 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000049)=0.000000000000000E+00 beta (00000050)=0.138619238803000E+02 gamma(00000050)=0.138619238803000E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 50 z1= 1 -.356147347967020E-06 0.000000000000000E+00 z1= 2 -.456564346990821E-07 0.000000000000000E+00 z1= 3 0.277672206175058E-01 0.000000000000000E+00 alpha(00000050)=0.000000000000000E+00 beta (00000051)=0.127745785751999E+02 gamma(00000051)=0.127745785751999E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 51 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000051)=0.000000000000000E+00 beta (00000052)=0.133888677550893E+02 gamma(00000052)=0.133888677550893E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 52 z1= 1 0.363398099267171E-06 0.000000000000000E+00 z1= 2 0.495963347540507E-07 0.000000000000000E+00 z1= 3 -.260939677259145E-01 0.000000000000000E+00 alpha(00000052)=0.000000000000000E+00 beta (00000053)=0.126291470295411E+02 gamma(00000053)=0.126291470295411E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 53 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000053)=0.000000000000000E+00 beta (00000054)=0.132483566544985E+02 gamma(00000054)=0.132483566544985E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 54 z1= 1 -.354927288835822E-06 0.000000000000000E+00 z1= 2 -.538726390485536E-07 0.000000000000000E+00 z1= 3 0.244847456023968E-01 0.000000000000000E+00 alpha(00000054)=0.000000000000000E+00 beta (00000055)=0.133544744446064E+02 gamma(00000055)=0.133544744446064E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 55 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000055)=0.000000000000000E+00 beta (00000056)=0.135533921360716E+02 gamma(00000056)=0.135533921360716E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 56 z1= 1 0.360526266769234E-06 0.000000000000000E+00 z1= 2 0.598213433602481E-07 0.000000000000000E+00 z1= 3 -.238032053737455E-01 0.000000000000000E+00 alpha(00000056)=0.000000000000000E+00 beta (00000057)=0.131799130059979E+02 gamma(00000057)=0.131799130059979E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 57 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000057)=0.000000000000000E+00 beta (00000058)=0.132398842863453E+02 gamma(00000058)=0.132398842863453E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 58 z1= 1 -.371818211278123E-06 0.000000000000000E+00 z1= 2 -.666466507650079E-07 0.000000000000000E+00 z1= 3 0.233925177931377E-01 0.000000000000000E+00 alpha(00000058)=0.000000000000000E+00 beta (00000059)=0.127465048558932E+02 gamma(00000059)=0.127465048558932E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 59 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000059)=0.000000000000000E+00 beta (00000060)=0.136005180609316E+02 gamma(00000060)=0.136005180609316E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 60 z1= 1 0.349336137327790E-06 0.000000000000000E+00 z1= 2 0.698562116973559E-07 0.000000000000000E+00 z1= 3 -.216461170613597E-01 0.000000000000000E+00 alpha(00000060)=0.000000000000000E+00 beta (00000061)=0.132678832829327E+02 gamma(00000061)=0.132678832829327E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 61 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000061)=0.000000000000000E+00 beta (00000062)=0.139178908653087E+02 gamma(00000062)=0.139178908653087E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 62 z1= 1 -.330036168293179E-06 0.000000000000000E+00 z1= 2 -.741675099880036E-07 0.000000000000000E+00 z1= 3 0.203694946486254E-01 0.000000000000000E+00 alpha(00000062)=0.000000000000000E+00 beta (00000063)=0.131207418384854E+02 gamma(00000063)=0.131207418384854E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 63 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000063)=0.000000000000000E+00 beta (00000064)=0.135797845953260E+02 gamma(00000064)=0.135797845953260E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 64 z1= 1 0.314591956787798E-06 0.000000000000000E+00 z1= 2 0.799064216890327E-07 0.000000000000000E+00 z1= 3 -.193892628801814E-01 0.000000000000000E+00 alpha(00000064)=0.000000000000000E+00 beta (00000065)=0.125572690909315E+02 gamma(00000065)=0.125572690909315E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 65 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000065)=0.000000000000000E+00 beta (00000066)=0.134171267751231E+02 gamma(00000066)=0.134171267751231E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 66 z1= 1 -.294704591785491E-06 0.000000000000000E+00 z1= 2 -.834475082086910E-07 0.000000000000000E+00 z1= 3 0.178765885426001E-01 0.000000000000000E+00 alpha(00000066)=0.000000000000000E+00 beta (00000067)=0.132069998444823E+02 gamma(00000067)=0.132069998444823E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 67 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000067)=0.000000000000000E+00 beta (00000068)=0.138669436233114E+02 gamma(00000068)=0.138669436233114E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 68 z1= 1 0.282189888662623E-06 0.000000000000000E+00 z1= 2 0.870971156767888E-07 0.000000000000000E+00 z1= 3 -.168651681058503E-01 0.000000000000000E+00 alpha(00000068)=0.000000000000000E+00 beta (00000069)=0.130391536594225E+02 gamma(00000069)=0.130391536594225E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 69 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000069)=0.000000000000000E+00 beta (00000070)=0.133420149542579E+02 gamma(00000070)=0.133420149542579E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 70 z1= 1 -.277704236563078E-06 0.000000000000000E+00 z1= 2 -.933464033758737E-07 0.000000000000000E+00 z1= 3 0.163359021256016E-01 0.000000000000000E+00 alpha(00000070)=0.000000000000000E+00 beta (00000071)=0.127754735301905E+02 gamma(00000071)=0.127754735301905E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 71 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000071)=0.000000000000000E+00 beta (00000072)=0.139992880108708E+02 gamma(00000072)=0.139992880108708E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 72 z1= 1 0.258202303573575E-06 0.000000000000000E+00 z1= 2 0.935432255774228E-07 0.000000000000000E+00 z1= 3 -.148089858234519E-01 0.000000000000000E+00 alpha(00000072)=0.000000000000000E+00 beta (00000073)=0.128546511178769E+02 gamma(00000073)=0.128546511178769E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 73 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000073)=0.000000000000000E+00 beta (00000074)=0.132957960506763E+02 gamma(00000074)=0.132957960506763E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 74 z1= 1 -.247655119992528E-06 0.000000000000000E+00 z1= 2 -.994106472587512E-07 0.000000000000000E+00 z1= 3 0.142243244583179E-01 0.000000000000000E+00 alpha(00000074)=0.000000000000000E+00 beta (00000075)=0.122777267581125E+02 gamma(00000075)=0.122777267581125E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 75 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000075)=0.000000000000000E+00 beta (00000076)=0.134301654935671E+02 gamma(00000076)=0.134301654935671E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 76 z1= 1 0.228628056089190E-06 0.000000000000000E+00 z1= 2 0.994874310366548E-07 0.000000000000000E+00 z1= 3 -.129315548638033E-01 0.000000000000000E+00 alpha(00000076)=0.000000000000000E+00 beta (00000077)=0.128560657605966E+02 gamma(00000077)=0.128560657605966E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 77 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000077)=0.000000000000000E+00 beta (00000078)=0.139567550500412E+02 gamma(00000078)=0.139567550500412E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 78 z1= 1 -.219229649362006E-06 0.000000000000000E+00 z1= 2 -.100562198862390E-06 0.000000000000000E+00 z1= 3 0.119216657532261E-01 0.000000000000000E+00 alpha(00000078)=0.000000000000000E+00 beta (00000079)=0.127756127467237E+02 gamma(00000079)=0.127756127467237E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 79 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000079)=0.000000000000000E+00 beta (00000080)=0.134013280979162E+02 gamma(00000080)=0.134013280979162E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 80 z1= 1 0.212425111173671E-06 0.000000000000000E+00 z1= 2 0.106117747872476E-06 0.000000000000000E+00 z1= 3 -.114307896885994E-01 0.000000000000000E+00 alpha(00000080)=0.000000000000000E+00 beta (00000081)=0.126747063945592E+02 gamma(00000081)=0.126747063945592E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 81 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000081)=0.000000000000000E+00 beta (00000082)=0.140252579609040E+02 gamma(00000082)=0.140252579609040E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 82 z1= 1 -.194591881645277E-06 0.000000000000000E+00 z1= 2 -.105398581092637E-06 0.000000000000000E+00 z1= 3 0.104015625816036E-01 0.000000000000000E+00 alpha(00000082)=0.000000000000000E+00 beta (00000083)=0.128491976183778E+02 gamma(00000083)=0.128491976183778E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 83 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000083)=0.000000000000000E+00 beta (00000084)=0.131673878266012E+02 gamma(00000084)=0.131673878266012E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 84 z1= 1 0.188172853978668E-06 0.000000000000000E+00 z1= 2 0.112613522773196E-06 0.000000000000000E+00 z1= 3 -.102532404724082E-01 0.000000000000000E+00 alpha(00000084)=0.000000000000000E+00 beta (00000085)=0.128600907054774E+02 gamma(00000085)=0.128600907054774E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 85 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000085)=0.000000000000000E+00 beta (00000086)=0.142145572515392E+02 gamma(00000086)=0.142145572515392E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 86 z1= 1 -.176191801684079E-06 0.000000000000000E+00 z1= 2 -.110515077913532E-06 0.000000000000000E+00 z1= 3 0.923024430151596E-02 0.000000000000000E+00 alpha(00000086)=0.000000000000000E+00 beta (00000087)=0.126364284679620E+02 gamma(00000087)=0.126364284679620E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 87 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000087)=0.000000000000000E+00 beta (00000088)=0.133498558996680E+02 gamma(00000088)=0.133498558996680E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 88 z1= 1 0.191139829414837E-06 0.000000000000000E+00 z1= 2 0.114174279389483E-06 0.000000000000000E+00 z1= 3 -.856240721492594E-02 0.000000000000000E+00 alpha(00000088)=0.000000000000000E+00 beta (00000089)=0.129282570042693E+02 gamma(00000089)=0.129282570042693E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 89 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000089)=0.000000000000000E+00 beta (00000090)=0.137915260786319E+02 gamma(00000090)=0.137915260786319E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 90 z1= 1 -.195891993858910E-06 0.000000000000000E+00 z1= 2 -.116445054897324E-06 0.000000000000000E+00 z1= 3 0.780722362553254E-02 0.000000000000000E+00 alpha(00000090)=0.000000000000000E+00 beta (00000091)=0.125622380257860E+02 gamma(00000091)=0.125622380257860E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 91 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000091)=0.000000000000000E+00 beta (00000092)=0.129073404166058E+02 gamma(00000092)=0.129073404166058E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 92 z1= 1 0.204321987525035E-06 0.000000000000000E+00 z1= 2 0.124748692032850E-06 0.000000000000000E+00 z1= 3 -.736944557845812E-02 0.000000000000000E+00 alpha(00000092)=0.000000000000000E+00 beta (00000093)=0.134136066082693E+02 gamma(00000093)=0.134136066082693E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 93 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000093)=0.000000000000000E+00 beta (00000094)=0.132877229157720E+02 gamma(00000094)=0.132877229157720E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 94 z1= 1 -.220637355732313E-06 0.000000000000000E+00 z1= 2 -.136115350534978E-06 0.000000000000000E+00 z1= 3 0.726616904362467E-02 0.000000000000000E+00 alpha(00000094)=0.000000000000000E+00 beta (00000095)=0.124147901860004E+02 gamma(00000095)=0.124147901860004E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 95 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000095)=0.000000000000000E+00 beta (00000096)=0.130372572965285E+02 gamma(00000096)=0.130372572965285E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 96 z1= 1 0.231655969040647E-06 0.000000000000000E+00 z1= 2 0.140359600974685E-06 0.000000000000000E+00 z1= 3 -.676483524981592E-02 0.000000000000000E+00 alpha(00000096)=0.000000000000000E+00 beta (00000097)=0.127828843653702E+02 gamma(00000097)=0.127828843653702E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 97 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000097)=0.000000000000000E+00 beta (00000098)=0.128636409101758E+02 gamma(00000098)=0.128636409101758E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 98 z1= 1 -.260495928629300E-06 0.000000000000000E+00 z1= 2 -.150697088746512E-06 0.000000000000000E+00 z1= 3 0.652984169821949E-02 0.000000000000000E+00 alpha(00000098)=0.000000000000000E+00 beta (00000099)=0.120951316262602E+02 gamma(00000099)=0.120951316262602E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 99 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000099)=0.000000000000000E+00 beta (00000100)=0.135705144543099E+02 gamma(00000100)=0.135705144543099E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 100 z1= 1 0.258175894256351E-06 0.000000000000000E+00 z1= 2 0.144070969097045E-06 0.000000000000000E+00 z1= 3 -.570298900775295E-02 0.000000000000000E+00 alpha(00000100)=0.000000000000000E+00 beta (00000101)=0.130003542707608E+02 gamma(00000101)=0.130003542707608E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 101 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000101)=0.000000000000000E+00 beta (00000102)=0.130515098053633E+02 gamma(00000102)=0.130515098053633E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 102 z1= 1 -.296003662191751E-06 0.000000000000000E+00 z1= 2 -.152197500098694E-06 0.000000000000000E+00 z1= 3 0.570634058498250E-02 0.000000000000000E+00 alpha(00000102)=0.000000000000000E+00 beta (00000103)=0.136735228958627E+02 gamma(00000103)=0.136735228958627E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 103 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000103)=0.000000000000000E+00 beta (00000104)=0.134250042282310E+02 gamma(00000104)=0.134250042282310E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 104 z1= 1 0.343086909450048E-06 0.000000000000000E+00 z1= 2 0.161772085080264E-06 0.000000000000000E+00 z1= 3 -.601801803827321E-02 0.000000000000000E+00 alpha(00000104)=0.000000000000000E+00 beta (00000105)=0.130029814491822E+02 gamma(00000105)=0.130029814491822E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 105 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000105)=0.000000000000000E+00 beta (00000106)=0.141250405720431E+02 gamma(00000106)=0.141250405720431E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 106 z1= 1 -.361513183816560E-06 0.000000000000000E+00 z1= 2 -.155689770822871E-06 0.000000000000000E+00 z1= 3 0.578940031076914E-02 0.000000000000000E+00 alpha(00000106)=0.000000000000000E+00 beta (00000107)=0.132679892624654E+02 gamma(00000107)=0.132679892624654E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 107 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000107)=0.000000000000000E+00 beta (00000108)=0.133905721061536E+02 gamma(00000108)=0.133905721061536E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 108 z1= 1 0.409171718783333E-06 0.000000000000000E+00 z1= 2 0.161780118013741E-06 0.000000000000000E+00 z1= 3 -.598199678082142E-02 0.000000000000000E+00 alpha(00000108)=0.000000000000000E+00 beta (00000109)=0.136743415245117E+02 gamma(00000109)=0.136743415245117E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 109 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000109)=0.000000000000000E+00 beta (00000110)=0.125334575444100E+02 gamma(00000110)=0.125334575444100E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 110 z1= 1 -.497144243055019E-06 0.000000000000000E+00 z1= 2 -.184279062487064E-06 0.000000000000000E+00 z1= 3 0.670164458315164E-02 0.000000000000000E+00 alpha(00000110)=0.000000000000000E+00 beta (00000111)=0.130342215629565E+02 gamma(00000111)=0.130342215629565E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 111 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000111)=0.000000000000000E+00 beta (00000112)=0.137473330656842E+02 gamma(00000112)=0.137473330656842E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 112 z1= 1 0.518483269950395E-06 0.000000000000000E+00 z1= 2 0.180630937548099E-06 0.000000000000000E+00 z1= 3 -.647042867075476E-02 0.000000000000000E+00 alpha(00000112)=0.000000000000000E+00 beta (00000113)=0.127037948327009E+02 gamma(00000113)=0.127037948327009E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 113 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000113)=0.000000000000000E+00 beta (00000114)=0.137811261139001E+02 gamma(00000114)=0.137811261139001E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 114 z1= 1 -.513548533342988E-06 0.000000000000000E+00 z1= 2 -.171663764525422E-06 0.000000000000000E+00 z1= 3 0.611782847722221E-02 0.000000000000000E+00 alpha(00000114)=0.000000000000000E+00 beta (00000115)=0.119877094885197E+02 gamma(00000115)=0.119877094885197E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 115 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000115)=0.000000000000000E+00 beta (00000116)=0.136754794056406E+02 gamma(00000116)=0.136754794056406E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 116 z1= 1 0.482280792821313E-06 0.000000000000000E+00 z1= 2 0.157041195404596E-06 0.000000000000000E+00 z1= 3 -.559987960993958E-02 0.000000000000000E+00 alpha(00000116)=0.000000000000000E+00 beta (00000117)=0.124468404429188E+02 gamma(00000117)=0.124468404429188E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 117 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000117)=0.000000000000000E+00 beta (00000118)=0.134802343412154E+02 gamma(00000118)=0.134802343412154E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 118 z1= 1 -.470428552420737E-06 0.000000000000000E+00 z1= 2 -.152668495468841E-06 0.000000000000000E+00 z1= 3 0.536283988320115E-02 0.000000000000000E+00 alpha(00000118)=0.000000000000000E+00 beta (00000119)=0.129047930020281E+02 gamma(00000119)=0.129047930020281E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 119 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000119)=0.000000000000000E+00 beta (00000120)=0.134429870023820E+02 gamma(00000120)=0.134429870023820E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 120 z1= 1 0.466639273957411E-06 0.000000000000000E+00 z1= 2 0.153779112236664E-06 0.000000000000000E+00 z1= 3 -.521282594904166E-02 0.000000000000000E+00 alpha(00000120)=0.000000000000000E+00 beta (00000121)=0.128150209364150E+02 gamma(00000121)=0.128150209364150E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 121 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000121)=0.000000000000000E+00 beta (00000122)=0.134033617985906E+02 gamma(00000122)=0.134033617985906E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 122 z1= 1 -.458456084317504E-06 0.000000000000000E+00 z1= 2 -.153682216447746E-06 0.000000000000000E+00 z1= 3 0.497734857171960E-02 0.000000000000000E+00 alpha(00000122)=0.000000000000000E+00 beta (00000123)=0.127879378753733E+02 gamma(00000123)=0.127879378753733E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 123 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000123)=0.000000000000000E+00 beta (00000124)=0.135159108977148E+02 gamma(00000124)=0.135159108977148E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 124 z1= 1 0.441328758307366E-06 0.000000000000000E+00 z1= 2 0.151497318303826E-06 0.000000000000000E+00 z1= 3 -.467126371904954E-02 0.000000000000000E+00 alpha(00000124)=0.000000000000000E+00 beta (00000125)=0.129566914304435E+02 gamma(00000125)=0.129566914304435E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 125 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000125)=0.000000000000000E+00 beta (00000126)=0.137778495879000E+02 gamma(00000126)=0.137778495879000E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 126 z1= 1 -.427646342576141E-06 0.000000000000000E+00 z1= 2 -.148260745231991E-06 0.000000000000000E+00 z1= 3 0.442556821296268E-02 0.000000000000000E+00 alpha(00000126)=0.000000000000000E+00 beta (00000127)=0.128495365124883E+02 gamma(00000127)=0.128495365124883E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 127 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000127)=0.000000000000000E+00 beta (00000128)=0.138112882405379E+02 gamma(00000128)=0.138112882405379E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 128 z1= 1 0.403926442140887E-06 0.000000000000000E+00 z1= 2 0.143705397538153E-06 0.000000000000000E+00 z1= 3 -.421853600812285E-02 0.000000000000000E+00 alpha(00000128)=0.000000000000000E+00 beta (00000129)=0.132562784026842E+02 gamma(00000129)=0.132562784026842E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 129 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000129)=0.000000000000000E+00 beta (00000130)=0.135026239168747E+02 gamma(00000130)=0.135026239168747E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 130 z1= 1 -.394229707045726E-06 0.000000000000000E+00 z1= 2 -.146584926560226E-06 0.000000000000000E+00 z1= 3 0.420672522326537E-02 0.000000000000000E+00 alpha(00000130)=0.000000000000000E+00 beta (00000131)=0.125003624723542E+02 gamma(00000131)=0.125003624723542E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 131 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000131)=0.000000000000000E+00 beta (00000132)=0.135182369827308E+02 gamma(00000132)=0.135182369827308E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 132 z1= 1 0.365566460358140E-06 0.000000000000000E+00 z1= 2 0.141450206890808E-06 0.000000000000000E+00 z1= 3 -.390074442346932E-02 0.000000000000000E+00 alpha(00000132)=0.000000000000000E+00 beta (00000133)=0.124859206593978E+02 gamma(00000133)=0.124859206593978E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 133 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000133)=0.000000000000000E+00 beta (00000134)=0.134673525098396E+02 gamma(00000134)=0.134673525098396E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 134 z1= 1 -.341306361658104E-06 0.000000000000000E+00 z1= 2 -.136866097561915E-06 0.000000000000000E+00 z1= 3 0.355805979442071E-02 0.000000000000000E+00 alpha(00000134)=0.000000000000000E+00 beta (00000135)=0.126728970301150E+02 gamma(00000135)=0.126728970301150E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 135 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000135)=0.000000000000000E+00 beta (00000136)=0.137296573429993E+02 gamma(00000136)=0.137296573429993E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 136 z1= 1 0.316676429819182E-06 0.000000000000000E+00 z1= 2 0.131663424867996E-06 0.000000000000000E+00 z1= 3 -.318709501312142E-02 0.000000000000000E+00 alpha(00000136)=0.000000000000000E+00 beta (00000137)=0.127646951906497E+02 gamma(00000137)=0.127646951906497E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 137 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000137)=0.000000000000000E+00 beta (00000138)=0.131132599083115E+02 gamma(00000138)=0.131132599083115E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 138 z1= 1 -.299070940338122E-06 0.000000000000000E+00 z1= 2 -.133677741322950E-06 0.000000000000000E+00 z1= 3 0.304725601387805E-02 0.000000000000000E+00 alpha(00000138)=0.000000000000000E+00 beta (00000139)=0.123813082104686E+02 gamma(00000139)=0.123813082104686E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 139 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000139)=0.000000000000000E+00 beta (00000140)=0.137849140920096E+02 gamma(00000140)=0.137849140920096E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 140 z1= 1 0.267654089528826E-06 0.000000000000000E+00 z1= 2 0.124915962719952E-06 0.000000000000000E+00 z1= 3 -.281294705334406E-02 0.000000000000000E+00 alpha(00000140)=0.000000000000000E+00 beta (00000141)=0.131108894062728E+02 gamma(00000141)=0.131108894062728E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 141 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000141)=0.000000000000000E+00 beta (00000142)=0.134910896096982E+02 gamma(00000142)=0.134910896096982E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 142 z1= 1 -.270701416141229E-06 0.000000000000000E+00 z1= 2 -.126476107014523E-06 0.000000000000000E+00 z1= 3 0.289754076806691E-02 0.000000000000000E+00 alpha(00000142)=0.000000000000000E+00 beta (00000143)=0.125627976985391E+02 gamma(00000143)=0.125627976985391E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 143 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000143)=0.000000000000000E+00 beta (00000144)=0.134860348338792E+02 gamma(00000144)=0.134860348338792E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 144 z1= 1 0.267298888877382E-06 0.000000000000000E+00 z1= 2 0.123168465693095E-06 0.000000000000000E+00 z1= 3 -.296572667861419E-02 0.000000000000000E+00 alpha(00000144)=0.000000000000000E+00 beta (00000145)=0.130284059981124E+02 gamma(00000145)=0.130284059981124E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 145 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000145)=0.000000000000000E+00 beta (00000146)=0.138278923437320E+02 gamma(00000146)=0.138278923437320E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 146 z1= 1 -.264890787216108E-06 0.000000000000000E+00 z1= 2 -.121508028856892E-06 0.000000000000000E+00 z1= 3 0.306723560892173E-02 0.000000000000000E+00 alpha(00000146)=0.000000000000000E+00 beta (00000147)=0.132057119559760E+02 gamma(00000147)=0.132057119559760E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 147 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000147)=0.000000000000000E+00 beta (00000148)=0.138745594752690E+02 gamma(00000148)=0.138745594752690E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 148 z1= 1 0.256968792396314E-06 0.000000000000000E+00 z1= 2 0.121965536330204E-06 0.000000000000000E+00 z1= 3 -.311358623671403E-02 0.000000000000000E+00 alpha(00000148)=0.000000000000000E+00 beta (00000149)=0.129264558846556E+02 gamma(00000149)=0.129264558846556E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 149 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000149)=0.000000000000000E+00 beta (00000150)=0.133833936220652E+02 gamma(00000150)=0.133833936220652E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 150 z1= 1 -.248524780492500E-06 0.000000000000000E+00 z1= 2 -.125160307655838E-06 0.000000000000000E+00 z1= 3 0.318890013494345E-02 0.000000000000000E+00 alpha(00000150)=0.000000000000000E+00 beta (00000151)=0.126485223855912E+02 gamma(00000151)=0.126485223855912E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 151 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000151)=0.000000000000000E+00 beta (00000152)=0.139238357399315E+02 gamma(00000152)=0.139238357399315E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 152 z1= 1 0.224586676004818E-06 0.000000000000000E+00 z1= 2 0.120533493287354E-06 0.000000000000000E+00 z1= 3 -.298281339838925E-02 0.000000000000000E+00 alpha(00000152)=0.000000000000000E+00 beta (00000153)=0.128200663703519E+02 gamma(00000153)=0.128200663703519E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 153 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000153)=0.000000000000000E+00 beta (00000154)=0.141815908481887E+02 gamma(00000154)=0.141815908481887E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 154 z1= 1 -.209905358648386E-06 0.000000000000000E+00 z1= 2 -.115747479794825E-06 0.000000000000000E+00 z1= 3 0.274358410081829E-02 0.000000000000000E+00 alpha(00000154)=0.000000000000000E+00 beta (00000155)=0.126169707096985E+02 gamma(00000155)=0.126169707096985E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 155 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000155)=0.000000000000000E+00 beta (00000156)=0.133080241148011E+02 gamma(00000156)=0.133080241148011E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 156 z1= 1 0.215052080671722E-06 0.000000000000000E+00 z1= 2 0.117221201718833E-06 0.000000000000000E+00 z1= 3 -.264068019942044E-02 0.000000000000000E+00 alpha(00000156)=0.000000000000000E+00 beta (00000157)=0.126397343674964E+02 gamma(00000157)=0.126397343674964E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 157 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000157)=0.000000000000000E+00 beta (00000158)=0.138195474867809E+02 gamma(00000158)=0.138195474867809E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 158 z1= 1 -.204406801040512E-06 0.000000000000000E+00 z1= 2 -.114517068626257E-06 0.000000000000000E+00 z1= 3 0.239267767344591E-02 0.000000000000000E+00 alpha(00000158)=0.000000000000000E+00 beta (00000159)=0.131172930665626E+02 gamma(00000159)=0.131172930665626E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 159 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000159)=0.000000000000000E+00 beta (00000160)=0.138220975660787E+02 gamma(00000160)=0.138220975660787E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 160 z1= 1 0.197047998077909E-06 0.000000000000000E+00 z1= 2 0.116530618789884E-06 0.000000000000000E+00 z1= 3 -.222859712886604E-02 0.000000000000000E+00 alpha(00000160)=0.000000000000000E+00 beta (00000161)=0.129639384782435E+02 gamma(00000161)=0.129639384782435E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 161 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000161)=0.000000000000000E+00 beta (00000162)=0.133309309569776E+02 gamma(00000162)=0.133309309569776E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 162 z1= 1 -.200536386779182E-06 0.000000000000000E+00 z1= 2 -.121317388769408E-06 0.000000000000000E+00 z1= 3 0.206316941282425E-02 0.000000000000000E+00 alpha(00000162)=0.000000000000000E+00 beta (00000163)=0.125189964253377E+02 gamma(00000163)=0.125189964253377E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 163 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000163)=0.000000000000000E+00 beta (00000164)=0.134918253831780E+02 gamma(00000164)=0.134918253831780E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 164 z1= 1 0.205556730353850E-06 0.000000000000000E+00 z1= 2 0.119543060922840E-06 0.000000000000000E+00 z1= 3 -.172227666607157E-02 0.000000000000000E+00 alpha(00000164)=0.000000000000000E+00 beta (00000165)=0.128802988500540E+02 gamma(00000165)=0.128802988500540E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 165 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000165)=0.000000000000000E+00 beta (00000166)=0.137804237320728E+02 gamma(00000166)=0.137804237320728E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 166 z1= 1 -.218645467185523E-06 0.000000000000000E+00 z1= 2 -.117942232141376E-06 0.000000000000000E+00 z1= 3 0.135762577662191E-02 0.000000000000000E+00 alpha(00000166)=0.000000000000000E+00 beta (00000167)=0.126265440655197E+02 gamma(00000167)=0.126265440655197E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 167 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000167)=0.000000000000000E+00 beta (00000168)=0.142374829214736E+02 gamma(00000168)=0.142374829214736E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 168 z1= 1 0.216780222662451E-06 0.000000000000000E+00 z1= 2 0.110160414171581E-06 0.000000000000000E+00 z1= 3 -.948287463914559E-03 0.000000000000000E+00 alpha(00000168)=0.000000000000000E+00 beta (00000169)=0.122837701610676E+02 gamma(00000169)=0.122837701610676E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 169 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000169)=0.000000000000000E+00 beta (00000170)=0.138940520964828E+02 gamma(00000170)=0.138940520964828E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 170 z1= 1 -.218407992672595E-06 0.000000000000000E+00 z1= 2 -.103015833015124E-06 0.000000000000000E+00 z1= 3 0.722135882947221E-03 0.000000000000000E+00 alpha(00000170)=0.000000000000000E+00 beta (00000171)=0.130693543202175E+02 gamma(00000171)=0.130693543202175E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 171 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000171)=0.000000000000000E+00 beta (00000172)=0.136271330759047E+02 gamma(00000172)=0.136271330759047E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 172 z1= 1 0.236443965417736E-06 0.000000000000000E+00 z1= 2 0.104821739229516E-06 0.000000000000000E+00 z1= 3 -.623504856898861E-03 0.000000000000000E+00 alpha(00000172)=0.000000000000000E+00 beta (00000173)=0.121811395637176E+02 gamma(00000173)=0.121811395637176E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 173 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000173)=0.000000000000000E+00 beta (00000174)=0.132891882786346E+02 gamma(00000174)=0.132891882786346E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 174 z1= 1 -.235354909422882E-06 0.000000000000000E+00 z1= 2 -.103511817795823E-06 0.000000000000000E+00 z1= 3 0.492982547640752E-03 0.000000000000000E+00 alpha(00000174)=0.000000000000000E+00 beta (00000175)=0.130057990731589E+02 gamma(00000175)=0.130057990731589E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 175 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000175)=0.000000000000000E+00 beta (00000176)=0.135814587558529E+02 gamma(00000176)=0.135814587558529E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 176 z1= 1 0.233116337293839E-06 0.000000000000000E+00 z1= 2 0.106968671095527E-06 0.000000000000000E+00 z1= 3 -.392392854141815E-03 0.000000000000000E+00 alpha(00000176)=0.000000000000000E+00 beta (00000177)=0.130879546167914E+02 gamma(00000177)=0.130879546167914E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 177 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000177)=0.000000000000000E+00 beta (00000178)=0.138044969229016E+02 gamma(00000178)=0.138044969229016E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 178 z1= 1 -.213641538498533E-06 0.000000000000000E+00 z1= 2 -.108770897223843E-06 0.000000000000000E+00 z1= 3 0.246728148528150E-03 0.000000000000000E+00 alpha(00000178)=0.000000000000000E+00 beta (00000179)=0.125845948558625E+02 gamma(00000179)=0.125845948558625E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 179 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000179)=0.000000000000000E+00 beta (00000180)=0.132832348865172E+02 gamma(00000180)=0.132832348865172E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 180 z1= 1 0.200776172535320E-06 0.000000000000000E+00 z1= 2 0.110408400522382E-06 0.000000000000000E+00 z1= 3 -.119747252357093E-03 0.000000000000000E+00 alpha(00000180)=0.000000000000000E+00 beta (00000181)=0.126678200129403E+02 gamma(00000181)=0.126678200129403E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 181 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000181)=0.000000000000000E+00 beta (00000182)=0.137049248109319E+02 gamma(00000182)=0.137049248109319E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 182 z1= 1 -.192503148019302E-06 0.000000000000000E+00 z1= 2 -.108068501962532E-06 0.000000000000000E+00 z1= 3 -.109680287628776E-04 0.000000000000000E+00 alpha(00000182)=0.000000000000000E+00 beta (00000183)=0.127935575955193E+02 gamma(00000183)=0.127935575955193E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 183 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000183)=0.000000000000000E+00 beta (00000184)=0.134631372384179E+02 gamma(00000184)=0.134631372384179E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 184 z1= 1 0.175575795400228E-06 0.000000000000000E+00 z1= 2 0.108310330300702E-06 0.000000000000000E+00 z1= 3 0.135200483967937E-03 0.000000000000000E+00 alpha(00000184)=0.000000000000000E+00 beta (00000185)=0.130776934696945E+02 gamma(00000185)=0.130776934696945E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 185 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000185)=0.000000000000000E+00 beta (00000186)=0.142074275997471E+02 gamma(00000186)=0.142074275997471E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 186 z1= 1 -.154535610210086E-06 0.000000000000000E+00 z1= 2 -.105164754139395E-06 0.000000000000000E+00 z1= 3 -.212620546585371E-03 0.000000000000000E+00 alpha(00000186)=0.000000000000000E+00 beta (00000187)=0.128286923028188E+02 gamma(00000187)=0.128286923028188E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 187 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000187)=0.000000000000000E+00 beta (00000188)=0.132173733942845E+02 gamma(00000188)=0.132173733942845E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 188 z1= 1 0.137719063031004E-06 0.000000000000000E+00 z1= 2 0.108180976390740E-06 0.000000000000000E+00 z1= 3 0.247067311764555E-03 0.000000000000000E+00 alpha(00000188)=0.000000000000000E+00 beta (00000189)=0.128569749739912E+02 gamma(00000189)=0.128569749739912E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 189 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000189)=0.000000000000000E+00 beta (00000190)=0.142159999782418E+02 gamma(00000190)=0.142159999782418E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 190 z1= 1 -.106640418719942E-06 0.000000000000000E+00 z1= 2 -.102711275126342E-06 0.000000000000000E+00 z1= 3 -.240804088224984E-03 0.000000000000000E+00 alpha(00000190)=0.000000000000000E+00 beta (00000191)=0.126038712702129E+02 gamma(00000191)=0.126038712702129E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 191 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000191)=0.000000000000000E+00 beta (00000192)=0.136580154874692E+02 gamma(00000192)=0.136580154874692E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 192 z1= 1 0.819462186921324E-07 0.000000000000000E+00 z1= 2 0.997949013423812E-07 0.000000000000000E+00 z1= 3 0.205611974224071E-03 0.000000000000000E+00 alpha(00000192)=0.000000000000000E+00 beta (00000193)=0.126334565398996E+02 gamma(00000193)=0.126334565398996E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 193 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000193)=0.000000000000000E+00 beta (00000194)=0.129256754316845E+02 gamma(00000194)=0.129256754316845E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 194 z1= 1 -.606324895068098E-07 0.000000000000000E+00 z1= 2 -.101970475641869E-06 0.000000000000000E+00 z1= 3 -.178780065801586E-03 0.000000000000000E+00 alpha(00000194)=0.000000000000000E+00 beta (00000195)=0.131620994546999E+02 gamma(00000195)=0.131620994546999E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 195 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000195)=0.000000000000000E+00 beta (00000196)=0.138486991899472E+02 gamma(00000196)=0.138486991899472E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 196 z1= 1 0.437027721708605E-07 0.000000000000000E+00 z1= 2 0.100645263936307E-06 0.000000000000000E+00 z1= 3 0.981136254829054E-04 0.000000000000000E+00 alpha(00000196)=0.000000000000000E+00 beta (00000197)=0.133176872848920E+02 gamma(00000197)=0.133176872848920E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 197 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000197)=0.000000000000000E+00 beta (00000198)=0.140086780255277E+02 gamma(00000198)=0.140086780255277E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 198 z1= 1 -.280648076882758E-07 0.000000000000000E+00 z1= 2 -.997409779963411E-07 0.000000000000000E+00 z1= 3 0.657025771271177E-04 0.000000000000000E+00 alpha(00000198)=0.000000000000000E+00 beta (00000199)=0.126231017916212E+02 gamma(00000199)=0.126231017916212E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 199 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000199)=0.000000000000000E+00 beta (00000200)=0.135471342699846E+02 gamma(00000200)=0.135471342699846E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 200 z1= 1 0.185014890052826E-07 0.000000000000000E+00 z1= 2 0.978800741872551E-07 0.000000000000000E+00 z1= 3 -.293523652700113E-03 0.000000000000000E+00 alpha(00000200)=0.000000000000000E+00 beta (00000201)=0.121664393797224E+02 gamma(00000201)=0.121664393797224E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 201 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000201)=0.000000000000000E+00 beta (00000202)=0.137621103275535E+02 gamma(00000202)=0.137621103275535E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 202 z1= 1 -.148525245872511E-07 0.000000000000000E+00 z1= 2 -.912979187387471E-07 0.000000000000000E+00 z1= 3 0.484331024216841E-03 0.000000000000000E+00 alpha(00000202)=0.000000000000000E+00 beta (00000203)=0.128304979330047E+02 gamma(00000203)=0.128304979330047E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 203 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000203)=0.000000000000000E+00 beta (00000204)=0.137473273719021E+02 gamma(00000204)=0.137473273719021E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 204 z1= 1 0.133328873315388E-07 0.000000000000000E+00 z1= 2 0.890057656752555E-07 0.000000000000000E+00 z1= 3 -.647454003086141E-03 0.000000000000000E+00 alpha(00000204)=0.000000000000000E+00 beta (00000205)=0.121748286481082E+02 gamma(00000205)=0.121748286481082E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 205 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000205)=0.000000000000000E+00 beta (00000206)=0.135409146048608E+02 gamma(00000206)=0.135409146048608E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 206 z1= 1 -.217189671988241E-07 0.000000000000000E+00 z1= 2 -.834728401237234E-07 0.000000000000000E+00 z1= 3 0.682095505293974E-03 0.000000000000000E+00 alpha(00000206)=0.000000000000000E+00 beta (00000207)=0.125235290062210E+02 gamma(00000207)=0.125235290062210E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 207 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000207)=0.000000000000000E+00 beta (00000208)=0.134816781875575E+02 gamma(00000208)=0.134816781875575E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 208 z1= 1 0.393766673642006E-07 0.000000000000000E+00 z1= 2 0.824471135605888E-07 0.000000000000000E+00 z1= 3 -.698704829445576E-03 0.000000000000000E+00 alpha(00000208)=0.000000000000000E+00 beta (00000209)=0.124235751590995E+02 gamma(00000209)=0.124235751590995E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 209 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000209)=0.000000000000000E+00 beta (00000210)=0.133912946107453E+02 gamma(00000210)=0.133912946107453E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 210 z1= 1 -.647393486413695E-07 0.000000000000000E+00 z1= 2 -.820455550012218E-07 0.000000000000000E+00 z1= 3 0.757073203937697E-03 0.000000000000000E+00 alpha(00000210)=0.000000000000000E+00 beta (00000211)=0.132521077480762E+02 gamma(00000211)=0.132521077480762E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 211 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000211)=0.000000000000000E+00 beta (00000212)=0.130575404284634E+02 gamma(00000212)=0.130575404284634E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 212 z1= 1 0.951406451470908E-07 0.000000000000000E+00 z1= 2 0.878992286904934E-07 0.000000000000000E+00 z1= 3 -.799318934853140E-03 0.000000000000000E+00 alpha(00000212)=0.000000000000000E+00 beta (00000213)=0.121344268931969E+02 gamma(00000213)=0.121344268931969E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 213 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000213)=0.000000000000000E+00 beta (00000214)=0.136940822300146E+02 gamma(00000214)=0.136940822300146E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 214 z1= 1 -.115699935410813E-06 0.000000000000000E+00 z1= 2 -.823167967413906E-07 0.000000000000000E+00 z1= 3 0.546961479871575E-03 0.000000000000000E+00 alpha(00000214)=0.000000000000000E+00 beta (00000215)=0.130546404787748E+02 gamma(00000215)=0.130546404787748E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 215 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000215)=0.000000000000000E+00 beta (00000216)=0.139907469540609E+02 gamma(00000216)=0.139907469540609E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 216 z1= 1 0.127252900167544E-06 0.000000000000000E+00 z1= 2 0.807340851015836E-07 0.000000000000000E+00 z1= 3 -.111367550438734E-03 0.000000000000000E+00 alpha(00000216)=0.000000000000000E+00 beta (00000217)=0.131053412866129E+02 gamma(00000217)=0.131053412866129E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 217 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000217)=0.000000000000000E+00 beta (00000218)=0.136145379810209E+02 gamma(00000218)=0.136145379810209E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 218 z1= 1 -.143289587425520E-06 0.000000000000000E+00 z1= 2 -.812844194852252E-07 0.000000000000000E+00 z1= 3 -.470341039806166E-03 0.000000000000000E+00 alpha(00000218)=0.000000000000000E+00 beta (00000219)=0.130737085161006E+02 gamma(00000219)=0.130737085161006E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 219 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000219)=0.000000000000000E+00 beta (00000220)=0.137872333186128E+02 gamma(00000220)=0.137872333186128E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 220 z1= 1 0.158630259396153E-06 0.000000000000000E+00 z1= 2 0.804744349969981E-07 0.000000000000000E+00 z1= 3 0.106681534071526E-02 0.000000000000000E+00 alpha(00000220)=0.000000000000000E+00 beta (00000221)=0.128028729662247E+02 gamma(00000221)=0.128028729662247E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 221 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000221)=0.000000000000000E+00 beta (00000222)=0.137338349451047E+02 gamma(00000222)=0.137338349451047E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 222 z1= 1 -.166763041487008E-06 0.000000000000000E+00 z1= 2 -.783905901930912E-07 0.000000000000000E+00 z1= 3 -.155536986698994E-02 0.000000000000000E+00 alpha(00000222)=0.000000000000000E+00 beta (00000223)=0.122029778863928E+02 gamma(00000223)=0.122029778863928E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 223 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000223)=0.000000000000000E+00 beta (00000224)=0.131574275553728E+02 gamma(00000224)=0.131574275553728E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 224 z1= 1 0.182092891496652E-06 0.000000000000000E+00 z1= 2 0.767055675397819E-07 0.000000000000000E+00 z1= 3 0.194544872407195E-02 0.000000000000000E+00 alpha(00000224)=0.000000000000000E+00 beta (00000225)=0.121479980370520E+02 gamma(00000225)=0.121479980370520E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 225 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000225)=0.000000000000000E+00 beta (00000226)=0.137841997851604E+02 gamma(00000226)=0.137841997851604E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 226 z1= 1 -.173653027010084E-06 0.000000000000000E+00 z1= 2 -.721067540513406E-07 0.000000000000000E+00 z1= 3 -.212629187572760E-02 0.000000000000000E+00 alpha(00000226)=0.000000000000000E+00 beta (00000227)=0.128716872415318E+02 gamma(00000227)=0.128716872415318E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 227 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000227)=0.000000000000000E+00 beta (00000228)=0.133599376210065E+02 gamma(00000228)=0.133599376210065E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 228 z1= 1 0.187860521359265E-06 0.000000000000000E+00 z1= 2 0.737611842821203E-07 0.000000000000000E+00 z1= 3 0.235190585904157E-02 0.000000000000000E+00 alpha(00000228)=0.000000000000000E+00 beta (00000229)=0.126508890921839E+02 gamma(00000229)=0.126508890921839E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 229 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000229)=0.000000000000000E+00 beta (00000230)=0.130544750686856E+02 gamma(00000230)=0.130544750686856E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 230 z1= 1 -.210253332953627E-06 0.000000000000000E+00 z1= 2 -.750723573126211E-07 0.000000000000000E+00 z1= 3 -.250690650037866E-02 0.000000000000000E+00 alpha(00000230)=0.000000000000000E+00 beta (00000231)=0.127900842738169E+02 gamma(00000231)=0.127900842738169E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 231 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000231)=0.000000000000000E+00 beta (00000232)=0.139958214978477E+02 gamma(00000232)=0.139958214978477E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 232 z1= 1 0.212134151253451E-06 0.000000000000000E+00 z1= 2 0.709278993893956E-07 0.000000000000000E+00 z1= 3 0.239200873239483E-02 0.000000000000000E+00 alpha(00000232)=0.000000000000000E+00 beta (00000233)=0.131324614187289E+02 gamma(00000233)=0.131324614187289E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 233 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000233)=0.000000000000000E+00 beta (00000234)=0.136723071865690E+02 gamma(00000234)=0.136723071865690E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 234 z1= 1 -.225486154371499E-06 0.000000000000000E+00 z1= 2 -.696422573808527E-07 0.000000000000000E+00 z1= 3 -.234319357989074E-02 0.000000000000000E+00 alpha(00000234)=0.000000000000000E+00 beta (00000235)=0.130063435560003E+02 gamma(00000235)=0.130063435560003E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 235 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000235)=0.000000000000000E+00 beta (00000236)=0.136793797268605E+02 gamma(00000236)=0.136793797268605E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 236 z1= 1 0.239061669896317E-06 0.000000000000000E+00 z1= 2 0.673487984010485E-07 0.000000000000000E+00 z1= 3 0.220559670446228E-02 0.000000000000000E+00 alpha(00000236)=0.000000000000000E+00 beta (00000237)=0.129605200023046E+02 gamma(00000237)=0.129605200023046E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 237 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000237)=0.000000000000000E+00 beta (00000238)=0.135509192795931E+02 gamma(00000238)=0.135509192795931E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 238 z1= 1 -.265058570136342E-06 0.000000000000000E+00 z1= 2 -.653666541762385E-07 0.000000000000000E+00 z1= 3 -.200618144630234E-02 0.000000000000000E+00 alpha(00000238)=0.000000000000000E+00 beta (00000239)=0.129572485570983E+02 gamma(00000239)=0.129572485570983E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 239 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000239)=0.000000000000000E+00 beta (00000240)=0.141677959249985E+02 gamma(00000240)=0.141677959249985E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 240 z1= 1 0.274525366066492E-06 0.000000000000000E+00 z1= 2 0.602900782207985E-07 0.000000000000000E+00 z1= 3 0.177700914867698E-02 0.000000000000000E+00 alpha(00000240)=0.000000000000000E+00 beta (00000241)=0.127858762204700E+02 gamma(00000241)=0.127858762204700E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 241 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000241)=0.000000000000000E+00 beta (00000242)=0.137129374350072E+02 gamma(00000242)=0.137129374350072E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 242 z1= 1 -.279176383267748E-06 0.000000000000000E+00 z1= 2 -.565070937016791E-07 0.000000000000000E+00 z1= 3 -.158889825969425E-02 0.000000000000000E+00 alpha(00000242)=0.000000000000000E+00 beta (00000243)=0.128810644521266E+02 gamma(00000243)=0.128810644521266E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 243 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000243)=0.000000000000000E+00 beta (00000244)=0.129023920430435E+02 gamma(00000244)=0.129023920430435E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 244 z1= 1 0.306960526536124E-06 0.000000000000000E+00 z1= 2 0.569191121330961E-07 0.000000000000000E+00 z1= 3 0.153738893847702E-02 0.000000000000000E+00 alpha(00000244)=0.000000000000000E+00 beta (00000245)=0.122178631573110E+02 gamma(00000245)=0.122178631573110E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 245 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000245)=0.000000000000000E+00 beta (00000246)=0.134655973047882E+02 gamma(00000246)=0.134655973047882E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 246 z1= 1 -.291826761977863E-06 0.000000000000000E+00 z1= 2 -.525788175541678E-07 0.000000000000000E+00 z1= 3 -.138155944261150E-02 0.000000000000000E+00 alpha(00000246)=0.000000000000000E+00 beta (00000247)=0.123261759614431E+02 gamma(00000247)=0.123261759614431E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 247 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000247)=0.000000000000000E+00 beta (00000248)=0.135306337006400E+02 gamma(00000248)=0.135306337006400E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 248 z1= 1 0.272817936026039E-06 0.000000000000000E+00 z1= 2 0.488147289149721E-07 0.000000000000000E+00 z1= 3 0.129951831971732E-02 0.000000000000000E+00 alpha(00000248)=0.000000000000000E+00 beta (00000249)=0.130329876729606E+02 gamma(00000249)=0.130329876729606E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 249 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000249)=0.000000000000000E+00 beta (00000250)=0.133723230694147E+02 gamma(00000250)=0.133723230694147E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 250 z1= 1 -.282268934527583E-06 0.000000000000000E+00 z1= 2 -.483038691259305E-07 0.000000000000000E+00 z1= 3 -.133838497638317E-02 0.000000000000000E+00 alpha(00000250)=0.000000000000000E+00 beta (00000251)=0.125956740705564E+02 gamma(00000251)=0.125956740705564E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 251 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000251)=0.000000000000000E+00 beta (00000252)=0.136070122551341E+02 gamma(00000252)=0.136070122551341E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 252 z1= 1 0.255377182264917E-06 0.000000000000000E+00 z1= 2 0.463800328715652E-07 0.000000000000000E+00 z1= 3 0.138846657704619E-02 0.000000000000000E+00 alpha(00000252)=0.000000000000000E+00 beta (00000253)=0.127858743079505E+02 gamma(00000253)=0.127858743079505E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 253 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000253)=0.000000000000000E+00 beta (00000254)=0.132358081950032E+02 gamma(00000254)=0.132358081950032E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 254 z1= 1 -.234169901970854E-06 0.000000000000000E+00 z1= 2 -.475175352331828E-07 0.000000000000000E+00 z1= 3 -.153715234223159E-02 0.000000000000000E+00 alpha(00000254)=0.000000000000000E+00 beta (00000255)=0.121427511592553E+02 gamma(00000255)=0.121427511592553E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 255 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000255)=0.000000000000000E+00 beta (00000256)=0.143751598688819E+02 gamma(00000256)=0.143751598688819E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 256 z1= 1 0.198376332165057E-06 0.000000000000000E+00 z1= 2 0.426014975783186E-07 0.000000000000000E+00 z1= 3 0.146834983038842E-02 0.000000000000000E+00 alpha(00000256)=0.000000000000000E+00 beta (00000257)=0.125263274861059E+02 gamma(00000257)=0.125263274861059E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 257 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000257)=0.000000000000000E+00 beta (00000258)=0.133616890351963E+02 gamma(00000258)=0.133616890351963E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 258 z1= 1 -.175788729045879E-06 0.000000000000000E+00 z1= 2 -.423335026712365E-07 0.000000000000000E+00 z1= 3 -.169136658471093E-02 0.000000000000000E+00 alpha(00000258)=0.000000000000000E+00 beta (00000259)=0.127923810363415E+02 gamma(00000259)=0.127923810363415E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 259 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000259)=0.000000000000000E+00 beta (00000260)=0.137669590115728E+02 gamma(00000260)=0.137669590115728E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 260 z1= 1 0.151966499376617E-06 0.000000000000000E+00 z1= 2 0.427876980632538E-07 0.000000000000000E+00 z1= 3 0.192263329072617E-02 0.000000000000000E+00 alpha(00000260)=0.000000000000000E+00 beta (00000261)=0.126234907055481E+02 gamma(00000261)=0.126234907055481E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 261 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000261)=0.000000000000000E+00 beta (00000262)=0.138366522601136E+02 gamma(00000262)=0.138366522601136E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 262 z1= 1 -.130141396399133E-06 0.000000000000000E+00 z1= 2 -.422930554223877E-07 0.000000000000000E+00 z1= 3 -.210622760995759E-02 0.000000000000000E+00 alpha(00000262)=0.000000000000000E+00 beta (00000263)=0.128959898700074E+02 gamma(00000263)=0.128959898700074E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 263 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000263)=0.000000000000000E+00 beta (00000264)=0.133015506310813E+02 gamma(00000264)=0.133015506310813E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 264 z1= 1 0.121578037211366E-06 0.000000000000000E+00 z1= 2 0.425502425060835E-07 0.000000000000000E+00 z1= 3 0.231917374990884E-02 0.000000000000000E+00 alpha(00000264)=0.000000000000000E+00 beta (00000265)=0.130100468756481E+02 gamma(00000265)=0.130100468756481E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 265 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000265)=0.000000000000000E+00 beta (00000266)=0.135350596873538E+02 gamma(00000266)=0.135350596873538E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 266 z1= 1 -.115275258466812E-06 0.000000000000000E+00 z1= 2 -.430996445874212E-07 0.000000000000000E+00 z1= 3 -.237159318341755E-02 0.000000000000000E+00 alpha(00000266)=0.000000000000000E+00 beta (00000267)=0.128615039825526E+02 gamma(00000267)=0.128615039825526E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 267 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000267)=0.000000000000000E+00 beta (00000268)=0.133347949882406E+02 gamma(00000268)=0.133347949882406E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 268 z1= 1 0.106138135922123E-06 0.000000000000000E+00 z1= 2 0.435306463984850E-07 0.000000000000000E+00 z1= 3 0.250976988338662E-02 0.000000000000000E+00 alpha(00000268)=0.000000000000000E+00 beta (00000269)=0.121018680408150E+02 gamma(00000269)=0.121018680408150E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 269 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000269)=0.000000000000000E+00 beta (00000270)=0.135291831499013E+02 gamma(00000270)=0.135291831499013E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 270 z1= 1 -.983718002208443E-07 0.000000000000000E+00 z1= 2 -.409816017555870E-07 0.000000000000000E+00 z1= 3 -.244008905155214E-02 0.000000000000000E+00 alpha(00000270)=0.000000000000000E+00 beta (00000271)=0.125622490352918E+02 gamma(00000271)=0.125622490352918E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 271 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000271)=0.000000000000000E+00 beta (00000272)=0.139105934247345E+02 gamma(00000272)=0.139105934247345E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 272 z1= 1 0.101177105057255E-06 0.000000000000000E+00 z1= 2 0.382416573418715E-07 0.000000000000000E+00 z1= 3 0.237697066924392E-02 0.000000000000000E+00 alpha(00000272)=0.000000000000000E+00 beta (00000273)=0.128218405238212E+02 gamma(00000273)=0.128218405238212E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 273 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000273)=0.000000000000000E+00 beta (00000274)=0.138030629612530E+02 gamma(00000274)=0.138030629612530E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 274 z1= 1 -.110397626252451E-06 0.000000000000000E+00 z1= 2 -.355758564076522E-07 0.000000000000000E+00 z1= 3 -.232000457518879E-02 0.000000000000000E+00 alpha(00000274)=0.000000000000000E+00 beta (00000275)=0.131283508448319E+02 gamma(00000275)=0.131283508448319E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 275 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000275)=0.000000000000000E+00 beta (00000276)=0.134506391134794E+02 gamma(00000276)=0.134506391134794E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 276 z1= 1 0.131889674681801E-06 0.000000000000000E+00 z1= 2 0.348969556882104E-07 0.000000000000000E+00 z1= 3 0.237954244554765E-02 0.000000000000000E+00 alpha(00000276)=0.000000000000000E+00 beta (00000277)=0.120983730641982E+02 gamma(00000277)=0.120983730641982E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 277 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000277)=0.000000000000000E+00 beta (00000278)=0.140362699538363E+02 gamma(00000278)=0.140362699538363E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 278 z1= 1 -.147278834420624E-06 0.000000000000000E+00 z1= 2 -.312582123891333E-07 0.000000000000000E+00 z1= 3 -.218941140182169E-02 0.000000000000000E+00 alpha(00000278)=0.000000000000000E+00 beta (00000279)=0.128343867338331E+02 gamma(00000279)=0.128343867338331E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 279 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000279)=0.000000000000000E+00 beta (00000280)=0.132035241421768E+02 gamma(00000280)=0.132035241421768E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 280 z1= 1 0.177597048198663E-06 0.000000000000000E+00 z1= 2 0.312741485497276E-07 0.000000000000000E+00 z1= 3 0.224738814413758E-02 0.000000000000000E+00 alpha(00000280)=0.000000000000000E+00 beta (00000281)=0.126296383737338E+02 gamma(00000281)=0.126296383737338E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 281 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000281)=0.000000000000000E+00 beta (00000282)=0.131165232583678E+02 gamma(00000282)=0.131165232583678E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 282 z1= 1 -.200175048357325E-06 0.000000000000000E+00 z1= 2 -.313159758252033E-07 0.000000000000000E+00 z1= 3 -.230873155457375E-02 0.000000000000000E+00 alpha(00000282)=0.000000000000000E+00 beta (00000283)=0.131275742261065E+02 gamma(00000283)=0.131275742261065E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 283 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000283)=0.000000000000000E+00 beta (00000284)=0.143339362625959E+02 gamma(00000284)=0.143339362625959E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 284 z1= 1 0.216531581407513E-06 0.000000000000000E+00 z1= 2 0.284553037842653E-07 0.000000000000000E+00 z1= 3 0.225771214256154E-02 0.000000000000000E+00 alpha(00000284)=0.000000000000000E+00 beta (00000285)=0.125045300116538E+02 gamma(00000285)=0.125045300116538E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 285 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000285)=0.000000000000000E+00 beta (00000286)=0.132262258548497E+02 gamma(00000286)=0.132262258548497E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 286 z1= 1 -.241805519094840E-06 0.000000000000000E+00 z1= 2 -.262502855947425E-07 0.000000000000000E+00 z1= 3 -.229638722538857E-02 0.000000000000000E+00 alpha(00000286)=0.000000000000000E+00 beta (00000287)=0.120365176038642E+02 gamma(00000287)=0.120365176038642E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 287 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000287)=0.000000000000000E+00 beta (00000288)=0.137286424453347E+02 gamma(00000288)=0.137286424453347E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 288 z1= 1 0.252304373997100E-06 0.000000000000000E+00 z1= 2 0.230035723555559E-07 0.000000000000000E+00 z1= 3 0.220300826268143E-02 0.000000000000000E+00 alpha(00000288)=0.000000000000000E+00 beta (00000289)=0.130405409917309E+02 gamma(00000289)=0.130405409917309E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 289 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000289)=0.000000000000000E+00 beta (00000290)=0.131657562892765E+02 gamma(00000290)=0.131657562892765E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 290 z1= 1 -.298759711951202E-06 0.000000000000000E+00 z1= 2 -.231362583323451E-07 0.000000000000000E+00 z1= 3 -.232322487528806E-02 0.000000000000000E+00 alpha(00000290)=0.000000000000000E+00 beta (00000291)=0.126883543402458E+02 gamma(00000291)=0.126883543402458E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 291 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000291)=0.000000000000000E+00 beta (00000292)=0.143988362748565E+02 gamma(00000292)=0.143988362748565E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 292 z1= 1 0.304988730288848E-06 0.000000000000000E+00 z1= 2 0.198891630421054E-07 0.000000000000000E+00 z1= 3 0.212983038625494E-02 0.000000000000000E+00 alpha(00000292)=0.000000000000000E+00 beta (00000293)=0.126194037509770E+02 gamma(00000293)=0.126194037509770E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 293 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000293)=0.000000000000000E+00 beta (00000294)=0.129215425505257E+02 gamma(00000294)=0.129215425505257E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 294 z1= 1 -.342949607238564E-06 0.000000000000000E+00 z1= 2 -.195315227271729E-07 0.000000000000000E+00 z1= 3 -.208167093171944E-02 0.000000000000000E+00 alpha(00000294)=0.000000000000000E+00 beta (00000295)=0.127216743294106E+02 gamma(00000295)=0.127216743294106E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 295 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000295)=0.000000000000000E+00 beta (00000296)=0.133273807988564E+02 gamma(00000296)=0.133273807988564E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 296 z1= 1 0.355605145576992E-06 0.000000000000000E+00 z1= 2 0.196445273815266E-07 0.000000000000000E+00 z1= 3 0.198532658301512E-02 0.000000000000000E+00 alpha(00000296)=0.000000000000000E+00 beta (00000297)=0.131109382803740E+02 gamma(00000297)=0.131109382803740E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 297 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000297)=0.000000000000000E+00 beta (00000298)=0.140227128388750E+02 gamma(00000298)=0.140227128388750E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 298 z1= 1 -.353595203038198E-06 0.000000000000000E+00 z1= 2 -.203015765693707E-07 0.000000000000000E+00 z1= 3 -.195916970387110E-02 0.000000000000000E+00 alpha(00000298)=0.000000000000000E+00 beta (00000299)=0.121726693166730E+02 gamma(00000299)=0.121726693166730E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 299 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000299)=0.000000000000000E+00 beta (00000300)=0.140903919065011E+02 gamma(00000300)=0.140903919065011E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 300 z1= 1 0.322934162885259E-06 0.000000000000000E+00 z1= 2 0.182275973812209E-07 0.000000000000000E+00 z1= 3 0.188311122485229E-02 0.000000000000000E+00 alpha(00000300)=0.000000000000000E+00 beta (00000301)=0.124140801534232E+02 gamma(00000301)=0.124140801534232E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 301 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000301)=0.000000000000000E+00 beta (00000302)=0.133588428536784E+02 gamma(00000302)=0.133588428536784E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 302 z1= 1 -.320303699605066E-06 0.000000000000000E+00 z1= 2 -.176449578455362E-07 0.000000000000000E+00 z1= 3 -.193490659276264E-02 0.000000000000000E+00 alpha(00000302)=0.000000000000000E+00 beta (00000303)=0.125640050669588E+02 gamma(00000303)=0.125640050669588E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 303 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000303)=0.000000000000000E+00 beta (00000304)=0.142311864566223E+02 gamma(00000304)=0.142311864566223E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 304 z1= 1 0.310192464648279E-06 0.000000000000000E+00 z1= 2 0.144371924084728E-07 0.000000000000000E+00 z1= 3 0.175263021471397E-02 0.000000000000000E+00 alpha(00000304)=0.000000000000000E+00 beta (00000305)=0.128710057747304E+02 gamma(00000305)=0.128710057747304E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 305 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000305)=0.000000000000000E+00 beta (00000306)=0.136724245141417E+02 gamma(00000306)=0.136724245141417E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 306 z1= 1 -.316896993481487E-06 0.000000000000000E+00 z1= 2 -.147547911383402E-07 0.000000000000000E+00 z1= 3 -.172421047697937E-02 0.000000000000000E+00 alpha(00000306)=0.000000000000000E+00 beta (00000307)=0.130517040727038E+02 gamma(00000307)=0.130517040727038E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 307 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000307)=0.000000000000000E+00 beta (00000308)=0.134142238110871E+02 gamma(00000308)=0.134142238110871E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 308 z1= 1 0.315112838632833E-06 0.000000000000000E+00 z1= 2 0.153114677225097E-07 0.000000000000000E+00 z1= 3 0.173723279940820E-02 0.000000000000000E+00 alpha(00000308)=0.000000000000000E+00 beta (00000309)=0.131029885690242E+02 gamma(00000309)=0.131029885690242E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 309 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000309)=0.000000000000000E+00 beta (00000310)=0.132557154239133E+02 gamma(00000310)=0.132557154239133E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 310 z1= 1 -.312066188054474E-06 0.000000000000000E+00 z1= 2 -.177206309990435E-07 0.000000000000000E+00 z1= 3 -.174181957792992E-02 0.000000000000000E+00 alpha(00000310)=0.000000000000000E+00 beta (00000311)=0.124118812666486E+02 gamma(00000311)=0.124118812666486E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 311 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000311)=0.000000000000000E+00 beta (00000312)=0.130977904975267E+02 gamma(00000312)=0.130977904975267E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 312 z1= 1 0.299507088636860E-06 0.000000000000000E+00 z1= 2 0.157251296124079E-07 0.000000000000000E+00 z1= 3 0.155989868642095E-02 0.000000000000000E+00 alpha(00000312)=0.000000000000000E+00 beta (00000313)=0.121252818041145E+02 gamma(00000313)=0.121252818041145E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 313 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000313)=0.000000000000000E+00 beta (00000314)=0.134915612548094E+02 gamma(00000314)=0.134915612548094E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 314 z1= 1 -.295622142464970E-06 0.000000000000000E+00 z1= 2 -.151151343234812E-07 0.000000000000000E+00 z1= 3 -.122446285950003E-02 0.000000000000000E+00 alpha(00000314)=0.000000000000000E+00 beta (00000315)=0.126599446072509E+02 gamma(00000315)=0.126599446072509E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 315 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000315)=0.000000000000000E+00 beta (00000316)=0.137962936324920E+02 gamma(00000316)=0.137962936324920E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 316 z1= 1 0.284775391293110E-06 0.000000000000000E+00 z1= 2 0.105398598315297E-07 0.000000000000000E+00 z1= 3 0.856865856482404E-03 0.000000000000000E+00 alpha(00000316)=0.000000000000000E+00 beta (00000317)=0.117936239040783E+02 gamma(00000317)=0.117936239040783E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 317 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000317)=0.000000000000000E+00 beta (00000318)=0.140626003248234E+02 gamma(00000318)=0.140626003248234E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 318 z1= 1 -.243278048784820E-06 0.000000000000000E+00 z1= 2 -.121951939538543E-07 0.000000000000000E+00 z1= 3 -.312736050781085E-03 0.000000000000000E+00 alpha(00000318)=0.000000000000000E+00 beta (00000319)=0.132591516907889E+02 gamma(00000319)=0.132591516907889E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 319 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000319)=0.000000000000000E+00 beta (00000320)=0.142321416744786E+02 gamma(00000320)=0.142321416744786E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 320 z1= 1 0.224136019367729E-06 0.000000000000000E+00 z1= 2 0.632720337343136E-08 0.000000000000000E+00 z1= 3 -.686879735202137E-04 0.000000000000000E+00 alpha(00000320)=0.000000000000000E+00 beta (00000321)=0.121309168996906E+02 gamma(00000321)=0.121309168996906E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 321 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000321)=0.000000000000000E+00 beta (00000322)=0.139685400614301E+02 gamma(00000322)=0.139685400614301E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 322 z1= 1 -.201120191132038E-06 0.000000000000000E+00 z1= 2 -.130113115698327E-07 0.000000000000000E+00 z1= 3 0.404186917362735E-03 0.000000000000000E+00 alpha(00000322)=0.000000000000000E+00 beta (00000323)=0.125263083507150E+02 gamma(00000323)=0.125263083507150E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 323 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000323)=0.000000000000000E+00 beta (00000324)=0.144756275346361E+02 gamma(00000324)=0.144756275346361E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 324 z1= 1 0.178280921940939E-06 0.000000000000000E+00 z1= 2 0.712405461068843E-08 0.000000000000000E+00 z1= 3 -.576010671969695E-03 0.000000000000000E+00 alpha(00000324)=0.000000000000000E+00 beta (00000325)=0.132320150958205E+02 gamma(00000325)=0.132320150958205E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 325 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000325)=0.000000000000000E+00 beta (00000326)=0.140795887004912E+02 gamma(00000326)=0.140795887004912E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 326 z1= 1 -.180974133667924E-06 0.000000000000000E+00 z1= 2 -.157785029504651E-07 0.000000000000000E+00 z1= 3 0.598100676924817E-03 0.000000000000000E+00 alpha(00000326)=0.000000000000000E+00 beta (00000327)=0.124203002250485E+02 gamma(00000327)=0.124203002250485E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 327 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000327)=0.000000000000000E+00 beta (00000328)=0.130749438699291E+02 gamma(00000328)=0.130749438699291E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 328 z1= 1 0.163221498137342E-06 0.000000000000000E+00 z1= 2 0.142795052823530E-07 0.000000000000000E+00 z1= 3 -.470888258500127E-03 0.000000000000000E+00 alpha(00000328)=0.000000000000000E+00 beta (00000329)=0.129431034073004E+02 gamma(00000329)=0.129431034073004E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 329 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000329)=0.000000000000000E+00 beta (00000330)=0.140672969387894E+02 gamma(00000330)=0.140672969387894E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 330 z1= 1 -.140345383882534E-06 0.000000000000000E+00 z1= 2 -.203634800638268E-07 0.000000000000000E+00 z1= 3 0.298561839711901E-03 0.000000000000000E+00 alpha(00000330)=0.000000000000000E+00 beta (00000331)=0.121088852548966E+02 gamma(00000331)=0.121088852548966E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 331 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000331)=0.000000000000000E+00 beta (00000332)=0.138128407688961E+02 gamma(00000332)=0.138128407688961E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 332 z1= 1 0.127664681341750E-06 0.000000000000000E+00 z1= 2 0.184262181906838E-07 0.000000000000000E+00 z1= 3 -.150141670673332E-03 0.000000000000000E+00 alpha(00000332)=0.000000000000000E+00 beta (00000333)=0.124213073676456E+02 gamma(00000333)=0.124213073676456E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 333 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000333)=0.000000000000000E+00 beta (00000334)=0.130377842079733E+02 gamma(00000334)=0.130377842079733E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 334 z1= 1 -.140131707781239E-06 0.000000000000000E+00 z1= 2 -.222369848283210E-07 0.000000000000000E+00 z1= 3 0.774601390846020E-04 0.000000000000000E+00 alpha(00000334)=0.000000000000000E+00 beta (00000335)=0.129511285117286E+02 gamma(00000335)=0.129511285117286E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 335 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000335)=0.000000000000000E+00 beta (00000336)=0.130408863352860E+02 gamma(00000336)=0.130408863352860E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 336 z1= 1 0.144931997415736E-06 0.000000000000000E+00 z1= 2 0.238208704087656E-07 0.000000000000000E+00 z1= 3 -.991755129249559E-04 0.000000000000000E+00 alpha(00000336)=0.000000000000000E+00 beta (00000337)=0.131189541328106E+02 gamma(00000337)=0.131189541328106E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 337 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000337)=0.000000000000000E+00 beta (00000338)=0.128727259715265E+02 gamma(00000338)=0.128727259715265E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 338 z1= 1 -.152913900532692E-06 0.000000000000000E+00 z1= 2 -.310014224302890E-07 0.000000000000000E+00 z1= 3 0.235813423527798E-03 0.000000000000000E+00 alpha(00000338)=0.000000000000000E+00 beta (00000339)=0.142106705239372E+02 gamma(00000339)=0.142106705239372E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 339 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000339)=0.000000000000000E+00 beta (00000340)=0.136916481782945E+02 gamma(00000340)=0.136916481782945E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 340 z1= 1 0.162147556871794E-06 0.000000000000000E+00 z1= 2 0.337093151036330E-07 0.000000000000000E+00 z1= 3 -.395293768126095E-03 0.000000000000000E+00 alpha(00000340)=0.000000000000000E+00 beta (00000341)=0.123076184756905E+02 gamma(00000341)=0.123076184756905E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 341 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000341)=0.000000000000000E+00 beta (00000342)=0.140778752859498E+02 gamma(00000342)=0.140778752859498E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 342 z1= 1 -.151747980726638E-06 0.000000000000000E+00 z1= 2 -.329400119984051E-07 0.000000000000000E+00 z1= 3 0.565511758795149E-03 0.000000000000000E+00 alpha(00000342)=0.000000000000000E+00 beta (00000343)=0.127762857184727E+02 gamma(00000343)=0.127762857184727E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 343 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000343)=0.000000000000000E+00 beta (00000344)=0.137381038693624E+02 gamma(00000344)=0.137381038693624E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 344 z1= 1 0.148043763716568E-06 0.000000000000000E+00 z1= 2 0.326472147025561E-07 0.000000000000000E+00 z1= 3 -.851653805849277E-03 0.000000000000000E+00 alpha(00000344)=0.000000000000000E+00 beta (00000345)=0.122363501101069E+02 gamma(00000345)=0.122363501101069E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 345 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000345)=0.000000000000000E+00 beta (00000346)=0.141397556196396E+02 gamma(00000346)=0.141397556196396E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 346 z1= 1 -.142353954800582E-06 0.000000000000000E+00 z1= 2 -.322999949478174E-07 0.000000000000000E+00 z1= 3 0.103551909443379E-02 0.000000000000000E+00 alpha(00000346)=0.000000000000000E+00 beta (00000347)=0.122371058059064E+02 gamma(00000347)=0.122371058059064E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 347 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000347)=0.000000000000000E+00 beta (00000348)=0.143491967324009E+02 gamma(00000348)=0.143491967324009E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 348 z1= 1 0.132626486451086E-06 0.000000000000000E+00 z1= 2 0.313395792202664E-07 0.000000000000000E+00 z1= 3 -.124012689170794E-02 0.000000000000000E+00 alpha(00000348)=0.000000000000000E+00 beta (00000349)=0.120249917066098E+02 gamma(00000349)=0.120249917066098E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 349 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000349)=0.000000000000000E+00 beta (00000350)=0.127199080975981E+02 gamma(00000350)=0.127199080975981E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 350 z1= 1 -.110970723054020E-06 0.000000000000000E+00 z1= 2 -.357359825301916E-07 0.000000000000000E+00 z1= 3 0.160501659407206E-02 0.000000000000000E+00 alpha(00000350)=0.000000000000000E+00 beta (00000351)=0.127834033090252E+02 gamma(00000351)=0.127834033090252E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 351 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000351)=0.000000000000000E+00 beta (00000352)=0.140169542861353E+02 gamma(00000352)=0.140169542861353E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 352 z1= 1 0.885209558294494E-07 0.000000000000000E+00 z1= 2 0.381328938517953E-07 0.000000000000000E+00 z1= 3 -.166783967070582E-02 0.000000000000000E+00 alpha(00000352)=0.000000000000000E+00 beta (00000353)=0.124533775053829E+02 gamma(00000353)=0.124533775053829E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 353 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000353)=0.000000000000000E+00 beta (00000354)=0.134439718046104E+02 gamma(00000354)=0.134439718046104E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 354 z1= 1 -.578558404352265E-07 0.000000000000000E+00 z1= 2 -.413334219071578E-07 0.000000000000000E+00 z1= 3 0.167864532421371E-02 0.000000000000000E+00 alpha(00000354)=0.000000000000000E+00 beta (00000355)=0.125788256084161E+02 gamma(00000355)=0.125788256084161E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 355 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000355)=0.000000000000000E+00 beta (00000356)=0.134619524603687E+02 gamma(00000356)=0.134619524603687E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 356 z1= 1 0.208949814763429E-07 0.000000000000000E+00 z1= 2 0.472099682612918E-07 0.000000000000000E+00 z1= 3 -.164557040911853E-02 0.000000000000000E+00 alpha(00000356)=0.000000000000000E+00 beta (00000357)=0.124464434747911E+02 gamma(00000357)=0.124464434747911E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 357 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000357)=0.000000000000000E+00 beta (00000358)=0.139960671391055E+02 gamma(00000358)=0.139960671391055E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 358 z1= 1 0.186450001145289E-07 0.000000000000000E+00 z1= 2 -.508125816607867E-07 0.000000000000000E+00 z1= 3 0.137480412175824E-02 0.000000000000000E+00 alpha(00000358)=0.000000000000000E+00 beta (00000359)=0.126725935013756E+02 gamma(00000359)=0.126725935013756E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 359 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000359)=0.000000000000000E+00 beta (00000360)=0.139392329351640E+02 gamma(00000360)=0.139392329351640E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 360 z1= 1 -.660897936997473E-07 0.000000000000000E+00 z1= 2 0.568427976196581E-07 0.000000000000000E+00 z1= 3 -.985839403579795E-03 0.000000000000000E+00 alpha(00000360)=0.000000000000000E+00 beta (00000361)=0.126815860748413E+02 gamma(00000361)=0.126815860748413E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 361 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000361)=0.000000000000000E+00 beta (00000362)=0.134458313890255E+02 gamma(00000362)=0.134458313890255E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 362 z1= 1 0.116653001237186E-06 0.000000000000000E+00 z1= 2 -.624790913643998E-07 0.000000000000000E+00 z1= 3 0.506400819306196E-03 0.000000000000000E+00 alpha(00000362)=0.000000000000000E+00 beta (00000363)=0.128757883381914E+02 gamma(00000363)=0.128757883381914E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 363 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000363)=0.000000000000000E+00 beta (00000364)=0.140216034469773E+02 gamma(00000364)=0.140216034469773E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 364 z1= 1 -.158383512212541E-06 0.000000000000000E+00 z1= 2 0.689507643706212E-07 0.000000000000000E+00 z1= 3 0.971352869229194E-04 0.000000000000000E+00 alpha(00000364)=0.000000000000000E+00 beta (00000365)=0.129567907205026E+02 gamma(00000365)=0.129567907205026E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 365 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000365)=0.000000000000000E+00 beta (00000366)=0.130215768400874E+02 gamma(00000366)=0.130215768400874E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 366 z1= 1 0.217773357531336E-06 0.000000000000000E+00 z1= 2 -.779394715555827E-07 0.000000000000000E+00 z1= 3 -.628253312986049E-03 0.000000000000000E+00 alpha(00000366)=0.000000000000000E+00 beta (00000367)=0.127364142470152E+02 gamma(00000367)=0.127364142470152E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 367 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000367)=0.000000000000000E+00 beta (00000368)=0.131500245996250E+02 gamma(00000368)=0.131500245996250E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 368 z1= 1 -.266502904050557E-06 0.000000000000000E+00 z1= 2 0.891018441814091E-07 0.000000000000000E+00 z1= 3 0.103718817562106E-02 0.000000000000000E+00 alpha(00000368)=0.000000000000000E+00 beta (00000369)=0.125977388941613E+02 gamma(00000369)=0.125977388941613E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 369 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000369)=0.000000000000000E+00 beta (00000370)=0.141035058363388E+02 gamma(00000370)=0.141035058363388E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 370 z1= 1 0.290909952349323E-06 0.000000000000000E+00 z1= 2 -.862678858954856E-07 0.000000000000000E+00 z1= 3 -.128791896869589E-02 0.000000000000000E+00 alpha(00000370)=0.000000000000000E+00 beta (00000371)=0.125952341840077E+02 gamma(00000371)=0.125952341840077E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 371 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000371)=0.000000000000000E+00 beta (00000372)=0.138036289369319E+02 gamma(00000372)=0.138036289369319E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 372 z1= 1 -.296628325940050E-06 0.000000000000000E+00 z1= 2 0.923116320071310E-07 0.000000000000000E+00 z1= 3 0.145080852523930E-02 0.000000000000000E+00 alpha(00000372)=0.000000000000000E+00 beta (00000373)=0.126540566464389E+02 gamma(00000373)=0.126540566464389E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 373 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000373)=0.000000000000000E+00 beta (00000374)=0.137356975882133E+02 gamma(00000374)=0.137356975882133E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 374 z1= 1 0.313232980860348E-06 0.000000000000000E+00 z1= 2 -.899762327922961E-07 0.000000000000000E+00 z1= 3 -.168685666819803E-02 0.000000000000000E+00 alpha(00000374)=0.000000000000000E+00 beta (00000375)=0.130424413850678E+02 gamma(00000375)=0.130424413850678E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 375 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000375)=0.000000000000000E+00 beta (00000376)=0.134060043822120E+02 gamma(00000376)=0.134060043822120E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 376 z1= 1 -.336874871412272E-06 0.000000000000000E+00 z1= 2 0.103374001445260E-06 0.000000000000000E+00 z1= 3 0.201178113319640E-02 0.000000000000000E+00 alpha(00000376)=0.000000000000000E+00 beta (00000377)=0.122115703723879E+02 gamma(00000377)=0.122115703723879E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 377 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000377)=0.000000000000000E+00 beta (00000378)=0.138778899916997E+02 gamma(00000378)=0.138778899916997E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 378 z1= 1 0.313703990232478E-06 0.000000000000000E+00 z1= 2 -.941040361682058E-07 0.000000000000000E+00 z1= 3 -.189824982595563E-02 0.000000000000000E+00 alpha(00000378)=0.000000000000000E+00 beta (00000379)=0.121595727318303E+02 gamma(00000379)=0.121595727318303E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 379 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000379)=0.000000000000000E+00 beta (00000380)=0.131647808848660E+02 gamma(00000380)=0.131647808848660E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 380 z1= 1 -.291207565478939E-06 0.000000000000000E+00 z1= 2 0.109024650485627E-06 0.000000000000000E+00 z1= 3 0.171935442217532E-02 0.000000000000000E+00 alpha(00000380)=0.000000000000000E+00 beta (00000381)=0.128758097718622E+02 gamma(00000381)=0.128758097718622E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 381 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000381)=0.000000000000000E+00 beta (00000382)=0.136508884264274E+02 gamma(00000382)=0.136508884264274E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 382 z1= 1 0.280842381562851E-06 0.000000000000000E+00 z1= 2 -.101585782491054E-06 0.000000000000000E+00 z1= 3 -.137800455657600E-02 0.000000000000000E+00 alpha(00000382)=0.000000000000000E+00 beta (00000383)=0.136748408118441E+02 gamma(00000383)=0.136748408118441E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 383 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000383)=0.000000000000000E+00 beta (00000384)=0.129461210152750E+02 gamma(00000384)=0.129461210152750E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 384 z1= 1 -.278474229182873E-06 0.000000000000000E+00 z1= 2 0.138250826431027E-06 0.000000000000000E+00 z1= 3 0.111405227904454E-02 0.000000000000000E+00 alpha(00000384)=0.000000000000000E+00 beta (00000385)=0.121480747616348E+02 gamma(00000385)=0.121480747616348E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 385 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000385)=0.000000000000000E+00 beta (00000386)=0.142767124338572E+02 gamma(00000386)=0.142767124338572E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 386 z1= 1 0.249163270659651E-06 0.000000000000000E+00 z1= 2 -.109172074834289E-06 0.000000000000000E+00 z1= 3 -.734385156302744E-03 0.000000000000000E+00 alpha(00000386)=0.000000000000000E+00 beta (00000387)=0.122954044433145E+02 gamma(00000387)=0.122954044433145E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 387 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000387)=0.000000000000000E+00 beta (00000388)=0.137802262787772E+02 gamma(00000388)=0.137802262787772E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 388 z1= 1 -.206016515484555E-06 0.000000000000000E+00 z1= 2 0.140129859990744E-06 0.000000000000000E+00 z1= 3 0.520418732363024E-03 0.000000000000000E+00 alpha(00000388)=0.000000000000000E+00 beta (00000389)=0.130648419692790E+02 gamma(00000389)=0.130648419692790E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 389 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000389)=0.000000000000000E+00 beta (00000390)=0.131802814130156E+02 gamma(00000390)=0.131802814130156E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 390 z1= 1 0.232330709001220E-06 0.000000000000000E+00 z1= 2 -.117113313710194E-06 0.000000000000000E+00 z1= 3 -.439973130347081E-03 0.000000000000000E+00 alpha(00000390)=0.000000000000000E+00 beta (00000391)=0.127461004169634E+02 gamma(00000391)=0.127461004169634E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 391 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000391)=0.000000000000000E+00 beta (00000392)=0.130713950608255E+02 gamma(00000392)=0.130713950608255E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 392 z1= 1 -.183828514943563E-06 0.000000000000000E+00 z1= 2 0.175328104962298E-06 0.000000000000000E+00 z1= 3 0.441592604212318E-03 0.000000000000000E+00 alpha(00000392)=0.000000000000000E+00 beta (00000393)=0.131141613309069E+02 gamma(00000393)=0.131141613309069E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 393 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000393)=0.000000000000000E+00 beta (00000394)=0.136971892403969E+02 gamma(00000394)=0.136971892403969E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 394 z1= 1 0.221469857517053E-06 0.000000000000000E+00 z1= 2 -.120869196219495E-06 0.000000000000000E+00 z1= 3 -.443148988373176E-03 0.000000000000000E+00 alpha(00000394)=0.000000000000000E+00 beta (00000395)=0.120899979145928E+02 gamma(00000395)=0.120899979145928E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 395 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000395)=0.000000000000000E+00 beta (00000396)=0.141226074471793E+02 gamma(00000396)=0.141226074471793E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 396 z1= 1 -.119871484367665E-06 0.000000000000000E+00 z1= 2 0.194943291737274E-06 0.000000000000000E+00 z1= 3 0.289439431952499E-03 0.000000000000000E+00 alpha(00000396)=0.000000000000000E+00 beta (00000397)=0.131400419995506E+02 gamma(00000397)=0.131400419995506E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 397 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000397)=0.000000000000000E+00 beta (00000398)=0.143729389928311E+02 gamma(00000398)=0.143729389928311E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 398 z1= 1 0.133831881613542E-06 0.000000000000000E+00 z1= 2 -.963046507828930E-07 0.000000000000000E+00 z1= 3 -.652689415559715E-04 0.000000000000000E+00 alpha(00000398)=0.000000000000000E+00 beta (00000399)=0.120316011319352E+02 gamma(00000399)=0.120316011319352E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 399 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000399)=0.000000000000000E+00 beta (00000400)=0.134547661435884E+02 gamma(00000400)=0.134547661435884E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 400 z1= 1 0.203294339809522E-08 0.000000000000000E+00 z1= 2 0.203716119919926E-06 0.000000000000000E+00 z1= 3 -.203076166294700E-03 0.000000000000000E+00 alpha(00000400)=0.000000000000000E+00 beta (00000401)=0.131294576490387E+02 gamma(00000401)=0.131294576490387E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 401 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000401)=0.000000000000000E+00 beta (00000402)=0.135132184220309E+02 gamma(00000402)=0.135132184220309E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 402 z1= 1 0.416927403499418E-07 0.000000000000000E+00 z1= 2 -.996809907964549E-07 0.000000000000000E+00 z1= 3 0.337103475541662E-03 0.000000000000000E+00 alpha(00000402)=0.000000000000000E+00 beta (00000403)=0.131009269105692E+02 gamma(00000403)=0.131009269105692E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 403 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000403)=0.000000000000000E+00 beta (00000404)=0.140298648876473E+02 gamma(00000404)=0.140298648876473E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 404 z1= 1 0.603424595582930E-07 0.000000000000000E+00 z1= 2 0.229735639920752E-06 0.000000000000000E+00 z1= 3 -.413600681439286E-03 0.000000000000000E+00 alpha(00000404)=0.000000000000000E+00 beta (00000405)=0.134178584726688E+02 gamma(00000405)=0.134178584726688E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 405 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000405)=0.000000000000000E+00 beta (00000406)=0.133781434204067E+02 gamma(00000406)=0.133781434204067E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 406 z1= 1 -.307284258980892E-08 0.000000000000000E+00 z1= 2 -.133961039585945E-06 0.000000000000000E+00 z1= 3 0.546791640875107E-03 0.000000000000000E+00 alpha(00000406)=0.000000000000000E+00 beta (00000407)=0.128772385463115E+02 gamma(00000407)=0.128772385463115E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 407 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000407)=0.000000000000000E+00 beta (00000408)=0.137245501271275E+02 gamma(00000408)=0.137245501271275E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 408 z1= 1 0.803252926805001E-07 0.000000000000000E+00 z1= 2 0.229793344199986E-06 0.000000000000000E+00 z1= 3 -.635089137106535E-03 0.000000000000000E+00 alpha(00000408)=0.000000000000000E+00 beta (00000409)=0.126372513541804E+02 gamma(00000409)=0.126372513541804E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 409 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000409)=0.000000000000000E+00 beta (00000410)=0.126812275935713E+02 gamma(00000410)=0.126812275935713E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 410 z1= 1 -.407600350008433E-07 0.000000000000000E+00 z1= 2 -.180815322905722E-06 0.000000000000000E+00 z1= 3 0.780800551019586E-03 0.000000000000000E+00 alpha(00000410)=0.000000000000000E+00 beta (00000411)=0.129343826508240E+02 gamma(00000411)=0.129343826508240E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 411 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000411)=0.000000000000000E+00 beta (00000412)=0.139482397163067E+02 gamma(00000412)=0.139482397163067E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 412 z1= 1 0.806842976761534E-07 0.000000000000000E+00 z1= 2 0.239416275318925E-06 0.000000000000000E+00 z1= 3 -.815276901972045E-03 0.000000000000000E+00 alpha(00000412)=0.000000000000000E+00 beta (00000413)=0.123085410933138E+02 gamma(00000413)=0.123085410933138E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 413 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000413)=0.000000000000000E+00 beta (00000414)=0.136856200451125E+02 gamma(00000414)=0.136856200451125E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 414 z1= 1 -.304191190681575E-07 0.000000000000000E+00 z1= 2 -.187378292010283E-06 0.000000000000000E+00 z1= 3 0.760146133278103E-03 0.000000000000000E+00 alpha(00000414)=0.000000000000000E+00 beta (00000415)=0.130320895080931E+02 gamma(00000415)=0.130320895080931E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 415 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000415)=0.000000000000000E+00 beta (00000416)=0.132085693030967E+02 gamma(00000416)=0.132085693030967E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 416 z1= 1 0.469008167772568E-07 0.000000000000000E+00 z1= 2 0.254457222980195E-06 0.000000000000000E+00 z1= 3 -.688738865405417E-03 0.000000000000000E+00 alpha(00000416)=0.000000000000000E+00 beta (00000417)=0.123348651828536E+02 gamma(00000417)=0.123348651828536E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 417 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000417)=0.000000000000000E+00 beta (00000418)=0.133819488153496E+02 gamma(00000418)=0.133819488153496E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 418 z1= 1 -.120667735480887E-07 0.000000000000000E+00 z1= 2 -.210233093095172E-06 0.000000000000000E+00 z1= 3 0.414073797591051E-03 0.000000000000000E+00 alpha(00000418)=0.000000000000000E+00 beta (00000419)=0.137392141824828E+02 gamma(00000419)=0.137392141824828E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 419 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000419)=0.000000000000000E+00 beta (00000420)=0.141072678596784E+02 gamma(00000420)=0.141072678596784E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 420 z1= 1 0.350174673494075E-07 0.000000000000000E+00 z1= 2 0.277346499551081E-06 0.000000000000000E+00 z1= 3 -.978241584735830E-04 0.000000000000000E+00 alpha(00000420)=0.000000000000000E+00 beta (00000421)=0.126043694405394E+02 gamma(00000421)=0.126043694405394E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 421 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000421)=0.000000000000000E+00 beta (00000422)=0.142396062131644E+02 gamma(00000422)=0.142396062131644E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 422 z1= 1 -.256999413384643E-08 0.000000000000000E+00 z1= 2 -.223260260279082E-06 0.000000000000000E+00 z1= 3 -.260416880285135E-03 0.000000000000000E+00 alpha(00000422)=0.000000000000000E+00 beta (00000423)=0.122538442981180E+02 gamma(00000423)=0.122538442981180E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 423 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000423)=0.000000000000000E+00 beta (00000424)=0.130726065416758E+02 gamma(00000424)=0.130726065416758E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 424 z1= 1 0.342712644082273E-07 0.000000000000000E+00 z1= 2 0.274318823626331E-06 0.000000000000000E+00 z1= 3 0.595332898340488E-03 0.000000000000000E+00 alpha(00000424)=0.000000000000000E+00 beta (00000425)=0.127676656311138E+02 gamma(00000425)=0.127676656311138E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 425 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000425)=0.000000000000000E+00 beta (00000426)=0.141528342413181E+02 gamma(00000426)=0.141528342413181E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 426 z1= 1 -.266992180593503E-07 0.000000000000000E+00 z1= 2 -.240564445330737E-06 0.000000000000000E+00 z1= 3 -.826004627589897E-03 0.000000000000000E+00 alpha(00000426)=0.000000000000000E+00 beta (00000427)=0.126279492036988E+02 gamma(00000427)=0.126279492036988E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 427 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000427)=0.000000000000000E+00 beta (00000428)=0.139995608786397E+02 gamma(00000428)=0.139995608786397E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 428 z1= 1 0.584059987049704E-07 0.000000000000000E+00 z1= 2 0.269156600891604E-06 0.000000000000000E+00 z1= 3 0.104949624463354E-02 0.000000000000000E+00 alpha(00000428)=0.000000000000000E+00 beta (00000429)=0.120467747955502E+02 gamma(00000429)=0.120467747955502E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 429 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000429)=0.000000000000000E+00 beta (00000430)=0.132421162255067E+02 gamma(00000430)=0.132421162255067E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 430 z1= 1 -.765420817304733E-07 0.000000000000000E+00 z1= 2 -.250531338666837E-06 0.000000000000000E+00 z1= 3 -.131579753171115E-02 0.000000000000000E+00 alpha(00000430)=0.000000000000000E+00 beta (00000431)=0.125725593162296E+02 gamma(00000431)=0.125725593162296E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 431 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000431)=0.000000000000000E+00 beta (00000432)=0.136228196501197E+02 gamma(00000432)=0.136228196501197E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 432 z1= 1 0.105564638208612E-06 0.000000000000000E+00 z1= 2 0.286129021106248E-06 0.000000000000000E+00 z1= 3 0.159511997133109E-02 0.000000000000000E+00 alpha(00000432)=0.000000000000000E+00 beta (00000433)=0.129183310512564E+02 gamma(00000433)=0.129183310512564E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 433 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000433)=0.000000000000000E+00 beta (00000434)=0.143201064945426E+02 gamma(00000434)=0.143201064945426E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 434 z1= 1 -.101402262802622E-06 0.000000000000000E+00 z1= 2 -.263301479020968E-06 0.000000000000000E+00 z1= 3 -.170544781826815E-02 0.000000000000000E+00 alpha(00000434)=0.000000000000000E+00 beta (00000435)=0.120694474686315E+02 gamma(00000435)=0.120694474686315E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 435 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000435)=0.000000000000000E+00 beta (00000436)=0.134851456373116E+02 gamma(00000436)=0.134851456373116E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 436 z1= 1 0.116363681343216E-06 0.000000000000000E+00 z1= 2 0.300883995657010E-06 0.000000000000000E+00 z1= 3 0.168266702065712E-02 0.000000000000000E+00 alpha(00000436)=0.000000000000000E+00 beta (00000437)=0.128046358983406E+02 gamma(00000437)=0.128046358983406E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 437 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000437)=0.000000000000000E+00 beta (00000438)=0.144184078161007E+02 gamma(00000438)=0.144184078161007E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 438 z1= 1 -.126808649227852E-06 0.000000000000000E+00 z1= 2 -.271951447970036E-06 0.000000000000000E+00 z1= 3 -.144984842178738E-02 0.000000000000000E+00 alpha(00000438)=0.000000000000000E+00 beta (00000439)=0.136342746466510E+02 gamma(00000439)=0.136342746466510E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 439 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000439)=0.000000000000000E+00 beta (00000440)=0.134225716455734E+02 gamma(00000440)=0.134225716455734E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 440 z1= 1 0.190683489703050E-06 0.000000000000000E+00 z1= 2 0.344335945815866E-06 0.000000000000000E+00 z1= 3 0.121934598925467E-02 0.000000000000000E+00 alpha(00000440)=0.000000000000000E+00 beta (00000441)=0.130707285226314E+02 gamma(00000441)=0.130707285226314E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 441 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000441)=0.000000000000000E+00 beta (00000442)=0.132176944796575E+02 gamma(00000442)=0.132176944796575E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 442 z1= 1 -.223137407433130E-06 0.000000000000000E+00 z1= 2 -.358262037262764E-06 0.000000000000000E+00 z1= 3 -.802642747137448E-03 0.000000000000000E+00 alpha(00000442)=0.000000000000000E+00 beta (00000443)=0.122158209862278E+02 gamma(00000443)=0.122158209862278E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 443 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000443)=0.000000000000000E+00 beta (00000444)=0.135652101198641E+02 gamma(00000444)=0.135652101198641E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 444 z1= 1 0.228506407352641E-06 0.000000000000000E+00 z1= 2 0.374844309996355E-06 0.000000000000000E+00 z1= 3 0.243581412047864E-03 0.000000000000000E+00 alpha(00000444)=0.000000000000000E+00 beta (00000445)=0.131952857773911E+02 gamma(00000445)=0.131952857773911E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 445 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000445)=0.000000000000000E+00 beta (00000446)=0.133119190330304E+02 gamma(00000446)=0.133119190330304E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 446 z1= 1 -.256354616537217E-06 0.000000000000000E+00 z1= 2 -.403452562895853E-06 0.000000000000000E+00 z1= 3 0.255810362396972E-03 0.000000000000000E+00 alpha(00000446)=0.000000000000000E+00 beta (00000447)=0.129373380792457E+02 gamma(00000447)=0.129373380792457E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 447 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000447)=0.000000000000000E+00 beta (00000448)=0.131017411708022E+02 gamma(00000448)=0.131017411708022E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 448 z1= 1 0.288283109518557E-06 0.000000000000000E+00 z1= 2 0.440329627194452E-06 0.000000000000000E+00 z1= 3 -.783871330635059E-03 0.000000000000000E+00 alpha(00000448)=0.000000000000000E+00 beta (00000449)=0.125829510069103E+02 gamma(00000449)=0.125829510069103E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 449 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000449)=0.000000000000000E+00 beta (00000450)=0.125753163594132E+02 gamma(00000450)=0.125753163594132E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 450 z1= 1 -.320186702542366E-06 0.000000000000000E+00 z1= 2 -.484754480854560E-06 0.000000000000000E+00 z1= 3 0.139161591101192E-02 0.000000000000000E+00 alpha(00000450)=0.000000000000000E+00 beta (00000451)=0.128762706810361E+02 gamma(00000451)=0.128762706810361E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 451 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000451)=0.000000000000000E+00 beta (00000452)=0.132353317010038E+02 gamma(00000452)=0.132353317010038E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 452 z1= 1 0.327431522652191E-06 0.000000000000000E+00 z1= 2 0.497824203698040E-06 0.000000000000000E+00 z1= 3 -.203969995152897E-02 0.000000000000000E+00 alpha(00000452)=0.000000000000000E+00 beta (00000453)=0.119892074446745E+02 gamma(00000453)=0.119892074446745E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 453 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000453)=0.000000000000000E+00 beta (00000454)=0.142353356580893E+02 gamma(00000454)=0.142353356580893E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 454 z1= 1 -.303517257890058E-06 0.000000000000000E+00 z1= 2 -.471529461469394E-06 0.000000000000000E+00 z1= 3 0.240765692830144E-02 0.000000000000000E+00 alpha(00000454)=0.000000000000000E+00 beta (00000455)=0.124193100318303E+02 gamma(00000455)=0.124193100318303E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 455 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000455)=0.000000000000000E+00 beta (00000456)=0.140349805953886E+02 gamma(00000456)=0.140349805953886E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 456 z1= 1 0.254128747343720E-06 0.000000000000000E+00 z1= 2 0.431847638126528E-06 0.000000000000000E+00 z1= 3 -.271111987052148E-02 0.000000000000000E+00 alpha(00000456)=0.000000000000000E+00 beta (00000457)=0.121805036820086E+02 gamma(00000457)=0.121805036820086E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 457 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000457)=0.000000000000000E+00 beta (00000458)=0.136427421770071E+02 gamma(00000458)=0.136427421770071E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 458 z1= 1 -.226328460474891E-06 0.000000000000000E+00 z1= 2 -.470399986536758E-06 0.000000000000000E+00 z1= 3 0.290500784538941E-02 0.000000000000000E+00 alpha(00000458)=0.000000000000000E+00 beta (00000459)=0.129430042309498E+02 gamma(00000459)=0.129430042309498E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 459 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000459)=0.000000000000000E+00 beta (00000460)=0.138439033158487E+02 gamma(00000460)=0.138439033158487E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 460 z1= 1 0.168658762978889E-06 0.000000000000000E+00 z1= 2 0.440594767165195E-06 0.000000000000000E+00 z1= 3 -.298962760086193E-02 0.000000000000000E+00 alpha(00000460)=0.000000000000000E+00 beta (00000461)=0.131838150894010E+02 gamma(00000461)=0.131838150894010E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 461 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000461)=0.000000000000000E+00 beta (00000462)=0.133082365412240E+02 gamma(00000462)=0.133082365412240E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 462 z1= 1 -.168263737457101E-06 0.000000000000000E+00 z1= 2 -.546843402164003E-06 0.000000000000000E+00 z1= 3 0.321494409426415E-02 0.000000000000000E+00 alpha(00000462)=0.000000000000000E+00 beta (00000463)=0.121149559767674E+02 gamma(00000463)=0.121149559767674E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 463 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000463)=0.000000000000000E+00 beta (00000464)=0.131270025392412E+02 gamma(00000464)=0.131270025392412E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 464 z1= 1 0.101085540713365E-06 0.000000000000000E+00 z1= 2 0.493115690923052E-06 0.000000000000000E+00 z1= 3 -.329645126507171E-02 0.000000000000000E+00 alpha(00000464)=0.000000000000000E+00 beta (00000465)=0.127467666684824E+02 gamma(00000465)=0.127467666684824E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 465 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000465)=0.000000000000000E+00 beta (00000466)=0.139992478907518E+02 gamma(00000466)=0.139992478907518E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 466 z1= 1 -.115454694410184E-06 0.000000000000000E+00 z1= 2 -.594487462247245E-06 0.000000000000000E+00 z1= 3 0.326125194626761E-02 0.000000000000000E+00 alpha(00000466)=0.000000000000000E+00 beta (00000467)=0.126829610230465E+02 gamma(00000467)=0.126829610230465E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 467 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000467)=0.000000000000000E+00 beta (00000468)=0.134647579786051E+02 gamma(00000468)=0.134647579786051E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 468 z1= 1 0.384749859963377E-07 0.000000000000000E+00 z1= 2 0.500009461469868E-06 0.000000000000000E+00 z1= 3 -.322992404243496E-02 0.000000000000000E+00 alpha(00000468)=0.000000000000000E+00 beta (00000469)=0.134414509087157E+02 gamma(00000469)=0.134414509087157E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 469 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000469)=0.000000000000000E+00 beta (00000470)=0.142693121591174E+02 gamma(00000470)=0.142693121591174E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 470 z1= 1 -.866743871469279E-07 0.000000000000000E+00 z1= 2 -.662889783969826E-06 0.000000000000000E+00 z1= 3 0.311671798560902E-02 0.000000000000000E+00 alpha(00000470)=0.000000000000000E+00 beta (00000471)=0.124816893409690E+02 gamma(00000471)=0.124816893409690E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 471 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000471)=0.000000000000000E+00 beta (00000472)=0.135398848702985E+02 gamma(00000472)=0.135398848702985E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 472 z1= 1 0.969974793898782E-09 0.000000000000000E+00 z1= 2 0.543788625875850E-06 0.000000000000000E+00 z1= 3 -.297229994876277E-02 0.000000000000000E+00 alpha(00000472)=0.000000000000000E+00 beta (00000473)=0.125239661707567E+02 gamma(00000473)=0.125239661707567E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 473 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000473)=0.000000000000000E+00 beta (00000474)=0.139551184598186E+02 gamma(00000474)=0.139551184598186E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 474 z1= 1 -.605534104119749E-07 0.000000000000000E+00 z1= 2 -.677448061598492E-06 0.000000000000000E+00 z1= 3 0.283971841746540E-02 0.000000000000000E+00 alpha(00000474)=0.000000000000000E+00 beta (00000475)=0.128982886338608E+02 gamma(00000475)=0.128982886338608E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 475 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000475)=0.000000000000000E+00 beta (00000476)=0.134007707524405E+02 gamma(00000476)=0.134007707524405E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 476 z1= 1 0.262535966816615E-07 0.000000000000000E+00 z1= 2 0.598151437928912E-06 0.000000000000000E+00 z1= 3 -.297641404184927E-02 0.000000000000000E+00 alpha(00000476)=0.000000000000000E+00 beta (00000477)=0.132696493784929E+02 gamma(00000477)=0.132696493784929E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 477 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000477)=0.000000000000000E+00 beta (00000478)=0.146383535803333E+02 gamma(00000478)=0.146383535803333E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 478 z1= 1 -.110274503169053E-06 0.000000000000000E+00 z1= 2 -.711544440389067E-06 0.000000000000000E+00 z1= 3 0.295744658546140E-02 0.000000000000000E+00 alpha(00000478)=0.000000000000000E+00 beta (00000479)=0.124349895107824E+02 gamma(00000479)=0.124349895107824E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 479 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000479)=0.000000000000000E+00 beta (00000480)=0.133878895348755E+02 gamma(00000480)=0.133878895348755E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 480 z1= 1 0.118533991019765E-06 0.000000000000000E+00 z1= 2 0.665118917129895E-06 0.000000000000000E+00 z1= 3 -.305500323944793E-02 0.000000000000000E+00 alpha(00000480)=0.000000000000000E+00 beta (00000481)=0.124715665558587E+02 gamma(00000481)=0.124715665558587E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 481 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000481)=0.000000000000000E+00 beta (00000482)=0.135834970976825E+02 gamma(00000482)=0.135834970976825E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 482 z1= 1 -.177922837378666E-06 0.000000000000000E+00 z1= 2 -.730135214872286E-06 0.000000000000000E+00 z1= 3 0.303140589378120E-02 0.000000000000000E+00 alpha(00000482)=0.000000000000000E+00 beta (00000483)=0.125892781131097E+02 gamma(00000483)=0.125892781131097E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 483 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000483)=0.000000000000000E+00 beta (00000484)=0.138018419606281E+02 gamma(00000484)=0.138018419606281E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 484 z1= 1 0.224990274848481E-06 0.000000000000000E+00 z1= 2 0.746304599817194E-06 0.000000000000000E+00 z1= 3 -.302567917685843E-02 0.000000000000000E+00 alpha(00000484)=0.000000000000000E+00 beta (00000485)=0.129112541241461E+02 gamma(00000485)=0.129112541241461E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 485 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000485)=0.000000000000000E+00 beta (00000486)=0.134490324531267E+02 gamma(00000486)=0.134490324531267E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 486 z1= 1 -.284380494170431E-06 0.000000000000000E+00 z1= 2 -.782662815331002E-06 0.000000000000000E+00 z1= 3 0.317507997376657E-02 0.000000000000000E+00 alpha(00000486)=0.000000000000000E+00 beta (00000487)=0.125059367785215E+02 gamma(00000487)=0.125059367785215E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 487 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000487)=0.000000000000000E+00 beta (00000488)=0.132478820231828E+02 gamma(00000488)=0.132478820231828E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 488 z1= 1 0.381237094818938E-06 0.000000000000000E+00 z1= 2 0.893238983171976E-06 0.000000000000000E+00 z1= 3 -.327925472355219E-02 0.000000000000000E+00 alpha(00000488)=0.000000000000000E+00 beta (00000489)=0.128900357507148E+02 gamma(00000489)=0.128900357507148E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 489 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000489)=0.000000000000000E+00 beta (00000490)=0.138731736083544E+02 gamma(00000490)=0.138731736083544E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 490 z1= 1 -.394083616950166E-06 0.000000000000000E+00 z1= 2 -.825753854421303E-06 0.000000000000000E+00 z1= 3 0.332473696985663E-02 0.000000000000000E+00 alpha(00000490)=0.000000000000000E+00 beta (00000491)=0.131977914862043E+02 gamma(00000491)=0.131977914862043E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 491 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000491)=0.000000000000000E+00 beta (00000492)=0.131352079189244E+02 gamma(00000492)=0.131352079189244E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 492 z1= 1 0.547569277154462E-06 0.000000000000000E+00 z1= 2 0.106164530265030E-05 0.000000000000000E+00 z1= 3 -.360562396880103E-02 0.000000000000000E+00 alpha(00000492)=0.000000000000000E+00 beta (00000493)=0.123497008774162E+02 gamma(00000493)=0.123497008774162E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 493 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000493)=0.000000000000000E+00 beta (00000494)=0.144146010222359E+02 gamma(00000494)=0.144146010222359E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 494 z1= 1 -.486031467729581E-06 0.000000000000000E+00 z1= 2 -.843551950070927E-06 0.000000000000000E+00 z1= 3 0.332031330709293E-02 0.000000000000000E+00 alpha(00000494)=0.000000000000000E+00 beta (00000495)=0.121474230315534E+02 gamma(00000495)=0.121474230315534E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 495 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000495)=0.000000000000000E+00 beta (00000496)=0.141944742763666E+02 gamma(00000496)=0.141944742763666E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 496 z1= 1 0.597938911088574E-06 0.000000000000000E+00 z1= 2 0.102758608297459E-05 0.000000000000000E+00 z1= 3 -.304445906163135E-02 0.000000000000000E+00 alpha(00000496)=0.000000000000000E+00 beta (00000497)=0.126793759419183E+02 gamma(00000497)=0.126793759419183E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 497 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000497)=0.000000000000000E+00 beta (00000498)=0.139006895042117E+02 gamma(00000498)=0.139006895042117E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 498 z1= 1 -.547223202266653E-06 0.000000000000000E+00 z1= 2 -.828411094263665E-06 0.000000000000000E+00 z1= 3 0.290077255827098E-02 0.000000000000000E+00 alpha(00000498)=0.000000000000000E+00 beta (00000499)=0.122458885746495E+02 gamma(00000499)=0.122458885746495E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 499 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000499)=0.000000000000000E+00 beta (00000500)=0.137007265040862E+02 gamma(00000500)=0.137007265040862E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 500 z1= 1 0.727559565150585E-06 0.000000000000000E+00 z1= 2 0.113541318817079E-05 0.000000000000000E+00 z1= 3 -.275309015353666E-02 0.000000000000000E+00 alpha(00000500)=0.000000000000000E+00 beta (00000501)=0.128506603872104E+02 gamma(00000501)=0.128506603872104E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal End of Lanczos iterations Finished linear response calculation... lr_main : 144.01s CPU 153.74s WALL ( 1 calls) lr_solve_e : 0.25s CPU 0.26s WALL ( 1 calls) one_step : 143.37s CPU 152.92s WALL ( 1500 calls) lr_apply : 141.94s CPU 151.18s WALL ( 3006 calls) lr_apply_int : 90.41s CPU 95.88s WALL ( 1503 calls) lr_bse_int : 20.14s CPU 21.21s WALL ( 3006 calls) lr_apply_no : 51.53s CPU 55.30s WALL ( 1503 calls) lr_bse_noint : 25.19s CPU 27.22s WALL ( 1503 calls) lr_apply : 141.94s CPU 151.18s WALL ( 3006 calls) h_psi : 51.44s CPU 54.17s WALL ( 3006 calls) lr_calc_dens : 28.57s CPU 30.07s WALL ( 1503 calls) lr_ortho : 0.45s CPU 0.47s WALL ( 3000 calls) interaction : 21.94s CPU 23.43s WALL ( 1503 calls) lr_dot : 0.35s CPU 0.37s WALL ( 3753 calls) US routines lr_sm1_psi : 0.04s CPU 0.05s WALL ( 3006 calls) General routines calbec : 0.58s CPU 0.65s WALL ( 4587 calls) fft : 10.59s CPU 11.59s WALL ( 3009 calls) fftc : 27.88s CPU 30.27s WALL ( 96192 calls) fftw : 39.95s CPU 42.59s WALL ( 21178 calls) fftcw : 23.42s CPU 24.86s WALL ( 84184 calls) interpolate : 0.20s CPU 0.21s WALL ( 1503 calls) davcio : 0.00s CPU 0.00s WALL ( 49 calls) Parallel routines fft_scatter : 43.98s CPU 49.98s WALL ( 204563 calls) EXX routines exx_grid : 0.00s CPU 0.00s WALL ( 1 calls) exxinit : 0.01s CPU 0.01s WALL ( 1 calls) vexx : 25.51s CPU 26.73s WALL ( 3006 calls) exxen2 : 0.00s CPU 0.00s WALL ( 1 calls) TDDFPT : 2m24.03s CPU 2m33.77s WALL This run was terminated on: 20: 3:22 19Aug2012 =------------------------------------------------------------------------------= JOB DONE. =------------------------------------------------------------------------------= TDDFPT/Examples/CH4-ECUTFOCK/CH4.tddfpt_pp-in0000644000175000017500000000025012341371476016355 0ustar mbamba&lr_input prefix='ch4', outdir='./out', itermax=10000 itermax0=450 extrapolation="osc" epsil=0.01 end=3.50d0 increment=0.001d0 start=0.0d0 ipol=4 / TDDFPT/Examples/CH4-ECUTFOCK/Makefile0000644000175000017500000000077512341371476015141 0ustar mbambainclude ../make.sys NAME = CH4 default : all all : check_results check_results: $(NAME).pw-out $(NAME).tddfpt-out $(NAME).tddfpt_pp-out $(check_pw) $(NAME).pw-out $(NAME).pw-ref $(check_tddfpt) $(NAME).tddfpt-out $(NAME).tddfpt-ref small_test: $(NAME).pw-out $(NAME).tddfpt-st-out @$(check_pw) $(NAME).pw-out $(NAME).pw-ref @$(check_tddfpt) $(NAME).tddfpt-st-out $(NAME).tddfpt-st-ref clean : - /bin/rm -rf $(NAME).pw-out $(NAME).tddfpt-out $(NAME).tddfpt_pp-out $(NAME).tddfpt-st-out *.plot out/* TDDFPT/Examples/CH4-ECUTFOCK/CH4.tddfpt-st-ref0000644000175000017500000001411112341371476016451 0ustar mbamba Program TDDFPT v.5.0.1 starts on 19Aug2012 at 20: 0:34 This program is part of the open-source Quantum ESPRESSO suite for quantum simulation of materials; please cite "P. Giannozzi et al., J. Phys.:Condens. Matter 21 395502 (2009); URL http://www.quantum-espresso.org", in publications or presentations arising from this work. More details at http://www.quantum-espresso.org/quote.php Parallel version (MPI), running on 4 processors R & G space division: proc/pool = 4 ---------------------------------------- This is TDDFPT (Time Dependent Density Functional Perturbation Theory) Sub Version: 0.9 ---------------------------------------- Ultrasoft (Vanderbilt) Pseudopotentials Info: using nr1, nr2, nr3 values from input Info: using nr1s, nr2s, nr3s values from input IMPORTANT: XC functional enforced from input : Exchange-correlation = HF ( 5 0 0 0 0) EXX-fraction = 1.00 Any further DFT definition will be discarded Please, verify this is what you really want file H.pz-vbc.UPF: wavefunction(s) 1S renormalized Parallelization info -------------------- sticks: dense smooth PW G-vecs: dense smooth PW Min 445 445 108 14262 14262 1776 Max 452 452 110 14264 14264 1783 Sum 1789 1789 437 57051 57051 7123 Tot 895 895 219 EXX fraction changed: 1.00 EXX Screening parameter changed: 0.0000000 Subspace diagonalization in iterative solution of the eigenvalue problem: a serial algorithm will be used Lanczos linear response spectrum calculation Number of Lanczos iterations = 5 Gamma point algorithm Is it hybrid? T Is it hybrid? T Is it hybrid? T Is it hybrid? T lr_wfcinit_spectrum: finished lr_solve_e Norm of initial Lanczos vectors= 0.939778229070727 Starting Lanczos loop 1 Lanczos iteration: 1 z1= 1 0.000000000000000E+00 0.000000000000000E+00 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal alpha(00000001)=0.000000000000000E+00 beta (00000002)=0.202673021811089E+01 gamma(00000002)=0.202673021811089E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 2 z1= 1 0.629150058624703E+00 0.000000000000000E+00 alpha(00000002)=0.000000000000000E+00 beta (00000003)=0.676214891224268E+01 gamma(00000003)=0.676214891224268E+01 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 3 z1= 1 0.000000000000000E+00 0.000000000000000E+00 alpha(00000003)=0.000000000000000E+00 beta (00000004)=0.144232739820086E+02 gamma(00000004)=0.144232739820086E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 4 z1= 1 -.235142133460567E+00 0.000000000000000E+00 alpha(00000004)=0.000000000000000E+00 beta (00000005)=0.123530670086972E+02 gamma(00000005)=0.123530670086972E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 5 z1= 1 0.000000000000000E+00 0.000000000000000E+00 alpha(00000005)=0.000000000000000E+00 beta (00000006)=0.140729526537724E+02 gamma(00000006)=0.140729526537724E+02 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: applying interaction: normal End of Lanczos iterations Finished linear response calculation... lr_main : 0.84s CPU 0.87s WALL ( 1 calls) lr_solve_e : 0.09s CPU 0.09s WALL ( 1 calls) one_step : 0.52s CPU 0.54s WALL ( 5 calls) lr_apply : 0.52s CPU 0.53s WALL ( 12 calls) lr_apply_int : 0.34s CPU 0.34s WALL ( 6 calls) lr_bse_int : 0.06s CPU 0.07s WALL ( 12 calls) lr_apply_no : 0.18s CPU 0.19s WALL ( 6 calls) lr_bse_noint : 0.09s CPU 0.09s WALL ( 6 calls) lr_apply : 0.52s CPU 0.53s WALL ( 12 calls) h_psi : 0.18s CPU 0.19s WALL ( 12 calls) lr_calc_dens : 0.10s CPU 0.10s WALL ( 6 calls) lr_ortho : 0.00s CPU 0.00s WALL ( 10 calls) interaction : 0.10s CPU 0.11s WALL ( 6 calls) lr_dot : 0.00s CPU 0.00s WALL ( 8 calls) US routines lr_sm1_psi : 0.00s CPU 0.00s WALL ( 12 calls) General routines calbec : 0.01s CPU 0.01s WALL ( 44 calls) fft : 0.04s CPU 0.04s WALL ( 15 calls) fftc : 0.09s CPU 0.09s WALL ( 384 calls) fftw : 0.24s CPU 0.25s WALL ( 130 calls) fftcw : 0.08s CPU 0.08s WALL ( 352 calls) interpolate : 0.00s CPU 0.00s WALL ( 6 calls) davcio : 0.00s CPU 0.00s WALL ( 11 calls) Parallel routines fft_scatter : 0.16s CPU 0.17s WALL ( 881 calls) EXX routines exx_grid : 0.00s CPU 0.00s WALL ( 1 calls) exxinit : 0.01s CPU 0.01s WALL ( 1 calls) vexx : 0.09s CPU 0.09s WALL ( 12 calls) exxen2 : 0.01s CPU 0.01s WALL ( 1 calls) TDDFPT : 0.84s CPU 0.87s WALL This run was terminated on: 20: 0:35 19Aug2012 =------------------------------------------------------------------------------= JOB DONE. =------------------------------------------------------------------------------= TDDFPT/Examples/Benzene/0000755000175000017500000000000012341371517013273 5ustar mbambaTDDFPT/Examples/Benzene/Benzene.tddfpt-st-ref0000644000175000017500000001424412341371500017263 0ustar mbamba Program TDDFPT v.4.99 starts on 12Jan2012 at 11:55:23 This program is part of the open-source Quantum ESPRESSO suite for quantum simulation of materials; please cite "P. Giannozzi et al., J. Phys.:Condens. Matter 21 395502 (2009); URL http://www.quantum-espresso.org", in publications or presentations arising from this work. More details at http://www.quantum-espresso.org/quote.php Parallel version (MPI), running on 4 processors R & G space division: proc/pool = 4 ---------------------------------------- This is TDDFPT (Time Dependent Density Functional Perturbation Theory) Sub Version: 0.9 ---------------------------------------- Ultrasoft (Vanderbilt) Pseudopotentials Info: using nr1, nr2, nr3 values from input Info: using nr1s, nr2s, nr3s values from input IMPORTANT: XC functional enforced from input : Exchange-correlation = SLA PZ NOGX NOGC ( 1 1 0 0 0) EXX-fraction = 0.00 Any further DFT definition will be discarded Please, verify this is what you really want file C.pz-rrkjus.UPF: wavefunction(s) 2S renormalized file H.pz-rrkjus.UPF: wavefunction(s) 1S renormalized Parallelization info -------------------- sticks: dense smooth PW G-vecs: dense smooth PW Min 5091 2030 506 453838 114774 14329 Max 5094 2031 508 453840 114819 14336 Sum 20369 8121 2029 1815357 459173 57327 Tot 10185 4061 1015 negative rho (up, down): 0.964E-03 0.000E+00 Subspace diagonalization in iterative solution of the eigenvalue problem: a serial algorithm will be used Lanczos linear response spectrum calculation Number of Lanczos iterations = 5 Gamma point algorithm lr_wfcinit_spectrum: finished lr_solve_e Norm of initial Lanczos vectors= 3.850183350491884 Starting Lanczos loop 1 Lanczos iteration: 1 z1= 1 0.000000000000000E+00 0.000000000000000E+00 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.54462E-08 lr_apply_liouvillian: applying interaction: normal alpha(00000001)=0.000000000000000E+00 beta (00000002)=0.189710033590510E+01 gamma(00000002)=0.189710033590510E+01 lr_calc_dens: Charge drift due to real space implementation = 0.21024E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 2 z1= 1 0.217098129914084E+01 0.000000000000000E+00 alpha(00000002)=0.000000000000000E+00 beta (00000003)=0.894706678182303E+01 gamma(00000003)=0.894706678182303E+01 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.23014E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 3 z1= 1 0.000000000000000E+00 0.000000000000000E+00 alpha(00000003)=0.000000000000000E+00 beta (00000004)=0.140229218327977E+02 gamma(00000004)=0.140229218327977E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12866E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 4 z1= 1 -.107600311388071E+01 0.000000000000000E+00 alpha(00000004)=0.000000000000000E+00 beta (00000005)=0.113212811220899E+02 gamma(00000005)=0.113212811220899E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.28357E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 5 z1= 1 0.000000000000000E+00 0.000000000000000E+00 alpha(00000005)=0.000000000000000E+00 beta (00000006)=0.154788202005197E+02 gamma(00000006)=0.154788202005197E+02 lr_calc_dens: Charge drift due to real space implementation = -0.62754E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction End of Lanczos iterations Finished linear response calculation... lr_main : 29.85s CPU 30.59s WALL ( 1 calls) lr_solve_e : 8.39s CPU 8.43s WALL ( 1 calls) one_step : 14.94s CPU 15.40s WALL ( 5 calls) lr_apply : 14.70s CPU 15.16s WALL ( 12 calls) lr_apply_int : 11.59s CPU 12.03s WALL ( 6 calls) lr_apply_no : 3.11s CPU 3.13s WALL ( 6 calls) lr_apply : 14.70s CPU 15.16s WALL ( 12 calls) h_psi : 5.80s CPU 5.85s WALL ( 12 calls) lr_calc_dens : 3.38s CPU 3.50s WALL ( 6 calls) lr_ortho : 0.06s CPU 0.06s WALL ( 10 calls) interaction : 1.34s CPU 1.37s WALL ( 6 calls) lr_dot : 0.01s CPU 0.01s WALL ( 8 calls) US routines s_psi : 0.44s CPU 0.43s WALL ( 59 calls) lr_sm1_psi : 0.25s CPU 0.25s WALL ( 13 calls) General routines calbec : 0.73s CPU 0.73s WALL ( 83 calls) fft : 4.43s CPU 4.59s WALL ( 28 calls) ffts : 0.52s CPU 0.53s WALL ( 13 calls) fftw : 12.89s CPU 12.93s WALL ( 530 calls) interpolate : 2.88s CPU 3.07s WALL ( 13 calls) davcio : 0.00s CPU 0.03s WALL ( 11 calls) addusdens : 0.00s CPU 0.00s WALL ( 6 calls) Parallel routines fft_scatter : 3.79s CPU 3.87s WALL ( 571 calls) TDDFPT : 29.85s CPU 30.59s WALL This run was terminated on: 11:55:53 12Jan2012 =------------------------------------------------------------------------------= JOB DONE. =------------------------------------------------------------------------------= TDDFPT/Examples/Benzene/Benzene.tddfpt-ref0000644000175000017500001115024012341371500016636 0ustar mbamba Program TDDFPT v.4.99 starts on 12Jan2012 at 13:19:51 This program is part of the open-source Quantum ESPRESSO suite for quantum simulation of materials; please cite "P. Giannozzi et al., J. Phys.:Condens. Matter 21 395502 (2009); URL http://www.quantum-espresso.org", in publications or presentations arising from this work. More details at http://www.quantum-espresso.org/quote.php Parallel version (MPI), running on 4 processors R & G space division: proc/pool = 4 ---------------------------------------- This is TDDFPT (Time Dependent Density Functional Perturbation Theory) Sub Version: 0.9 ---------------------------------------- Ultrasoft (Vanderbilt) Pseudopotentials Info: using nr1, nr2, nr3 values from input Info: using nr1s, nr2s, nr3s values from input IMPORTANT: XC functional enforced from input : Exchange-correlation = SLA PZ NOGX NOGC ( 1 1 0 0 0) EXX-fraction = 0.00 Any further DFT definition will be discarded Please, verify this is what you really want file C.pz-rrkjus.UPF: wavefunction(s) 2S renormalized file H.pz-rrkjus.UPF: wavefunction(s) 1S renormalized Parallelization info -------------------- sticks: dense smooth PW G-vecs: dense smooth PW Min 5091 2030 506 453838 114774 14329 Max 5094 2031 508 453840 114819 14336 Sum 20369 8121 2029 1815357 459173 57327 Tot 10185 4061 1015 negative rho (up, down): 0.964E-03 0.000E+00 Subspace diagonalization in iterative solution of the eigenvalue problem: a serial algorithm will be used Lanczos linear response spectrum calculation Number of Lanczos iterations = 1500 Gamma point algorithm There are missing files! d0psi files can not be found,trying to recompansate lr_wfcinit_spectrum: finished lr_solve_e There are missing files! lanczos restart files can not be found, starting run from scratch Norm of initial Lanczos vectors= 3.850183350491884 Starting Lanczos loop 1 Lanczos iteration: 1 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.54462E-08 lr_apply_liouvillian: applying interaction: normal alpha(00000001)=0.000000000000000E+00 beta (00000002)=0.189710033590510E+01 gamma(00000002)=0.189710033590510E+01 lr_calc_dens: Charge drift due to real space implementation = 0.21024E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 2 z1= 1 0.217098129914084E+01 0.000000000000000E+00 z1= 2 0.105756622942495E-05 0.000000000000000E+00 z1= 3 0.118552261233304E-06 0.000000000000000E+00 alpha(00000002)=0.000000000000000E+00 beta (00000003)=0.894706678182303E+01 gamma(00000003)=0.894706678182303E+01 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.23014E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 3 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000003)=0.000000000000000E+00 beta (00000004)=0.140229218327977E+02 gamma(00000004)=0.140229218327977E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12866E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 4 z1= 1 -.107600311388071E+01 0.000000000000000E+00 z1= 2 0.608881456566190E-06 0.000000000000000E+00 z1= 3 0.717606817116177E-08 0.000000000000000E+00 alpha(00000004)=0.000000000000000E+00 beta (00000005)=0.113212811220899E+02 gamma(00000005)=0.113212811220899E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.28357E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 5 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000005)=0.000000000000000E+00 beta (00000006)=0.154788202005197E+02 gamma(00000006)=0.154788202005197E+02 lr_calc_dens: Charge drift due to real space implementation = -0.62754E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 6 z1= 1 0.698853988205774E+00 0.000000000000000E+00 z1= 2 -.967554420194371E-06 0.000000000000000E+00 z1= 3 -.403411258044548E-07 0.000000000000000E+00 alpha(00000006)=0.000000000000000E+00 beta (00000007)=0.112745179815090E+02 gamma(00000007)=0.112745179815090E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.23330E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 7 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000007)=0.000000000000000E+00 beta (00000008)=0.143382757760502E+02 gamma(00000008)=0.143382757760502E+02 lr_calc_dens: Charge drift due to real space implementation = 0.35773E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 8 z1= 1 -.496736161994749E+00 0.000000000000000E+00 z1= 2 0.139593677360591E-05 0.000000000000000E+00 z1= 3 0.444382354283291E-07 0.000000000000000E+00 alpha(00000008)=0.000000000000000E+00 beta (00000009)=0.126025694206781E+02 gamma(00000009)=0.126025694206781E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.45724E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 9 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000009)=0.000000000000000E+00 beta (00000010)=0.133390938670029E+02 gamma(00000010)=0.133390938670029E+02 lr_calc_dens: Charge drift due to real space implementation = -0.28519E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 10 z1= 1 0.435917829469724E+00 0.000000000000000E+00 z1= 2 -.275459600905742E-05 0.000000000000000E+00 z1= 3 -.668750753024774E-07 0.000000000000000E+00 alpha(00000010)=0.000000000000000E+00 beta (00000011)=0.131972497937500E+02 gamma(00000011)=0.131972497937500E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.54649E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 11 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000011)=0.000000000000000E+00 beta (00000012)=0.131994104735566E+02 gamma(00000012)=0.131994104735566E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11948E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 12 z1= 1 -.415740678899535E+00 0.000000000000000E+00 z1= 2 0.471923303320973E-05 0.000000000000000E+00 z1= 3 0.859126815251558E-07 0.000000000000000E+00 alpha(00000012)=0.000000000000000E+00 beta (00000013)=0.131511236482636E+02 gamma(00000013)=0.131511236482636E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.61275E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 13 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000013)=0.000000000000000E+00 beta (00000014)=0.134111792864264E+02 gamma(00000014)=0.134111792864264E+02 lr_calc_dens: Charge drift due to real space implementation = 0.16026E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 14 z1= 1 0.393683934095623E+00 0.000000000000000E+00 z1= 2 -.634306647314103E-05 0.000000000000000E+00 z1= 3 -.879032569508993E-07 0.000000000000000E+00 alpha(00000014)=0.000000000000000E+00 beta (00000015)=0.130423977661140E+02 gamma(00000015)=0.130423977661140E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.92580E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 15 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000015)=0.000000000000000E+00 beta (00000016)=0.134646831541159E+02 gamma(00000016)=0.134646831541159E+02 lr_calc_dens: Charge drift due to real space implementation = -0.40446E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 16 z1= 1 -.368653098156045E+00 0.000000000000000E+00 z1= 2 0.751069270591223E-05 0.000000000000000E+00 z1= 3 0.993825245769927E-07 0.000000000000000E+00 alpha(00000016)=0.000000000000000E+00 beta (00000017)=0.130267897117273E+02 gamma(00000017)=0.130267897117273E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10097E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 17 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000017)=0.000000000000000E+00 beta (00000018)=0.134374189449838E+02 gamma(00000018)=0.134374189449838E+02 lr_calc_dens: Charge drift due to real space implementation = -0.20330E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 18 z1= 1 0.343955077586594E+00 0.000000000000000E+00 z1= 2 -.839687979725060E-05 0.000000000000000E+00 z1= 3 -.103668022027626E-06 0.000000000000000E+00 alpha(00000018)=0.000000000000000E+00 beta (00000019)=0.130672504343459E+02 gamma(00000019)=0.130672504343459E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.85367E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 19 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000019)=0.000000000000000E+00 beta (00000020)=0.133972940888364E+02 gamma(00000020)=0.133972940888364E+02 lr_calc_dens: Charge drift due to real space implementation = 0.42119E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 20 z1= 1 -.320864819461988E+00 0.000000000000000E+00 z1= 2 0.875007848612957E-05 0.000000000000000E+00 z1= 3 0.103090485179205E-06 0.000000000000000E+00 alpha(00000020)=0.000000000000000E+00 beta (00000021)=0.132574128300769E+02 gamma(00000021)=0.132574128300769E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.47708E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 21 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000021)=0.000000000000000E+00 beta (00000022)=0.132785005266001E+02 gamma(00000022)=0.132785005266001E+02 lr_calc_dens: Charge drift due to real space implementation = -0.36469E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 22 z1= 1 0.305155180748200E+00 0.000000000000000E+00 z1= 2 -.981213872355315E-05 0.000000000000000E+00 z1= 3 -.119887649008733E-06 0.000000000000000E+00 alpha(00000022)=0.000000000000000E+00 beta (00000023)=0.133223801125315E+02 gamma(00000023)=0.133223801125315E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.28882E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 23 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000023)=0.000000000000000E+00 beta (00000024)=0.131932416980955E+02 gamma(00000024)=0.131932416980955E+02 lr_calc_dens: Charge drift due to real space implementation = 0.32660E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 24 z1= 1 -.293641993473396E+00 0.000000000000000E+00 z1= 2 0.110829244699875E-04 0.000000000000000E+00 z1= 3 0.110873048685408E-06 0.000000000000000E+00 alpha(00000024)=0.000000000000000E+00 beta (00000025)=0.132601852948385E+02 gamma(00000025)=0.132601852948385E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.18591E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 25 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000025)=0.000000000000000E+00 beta (00000026)=0.133093571286516E+02 gamma(00000026)=0.133093571286516E+02 lr_calc_dens: Charge drift due to real space implementation = -0.30107E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 26 z1= 1 0.279964426287167E+00 0.000000000000000E+00 z1= 2 -.132282525308535E-04 0.000000000000000E+00 z1= 3 -.100177013233250E-06 0.000000000000000E+00 alpha(00000026)=0.000000000000000E+00 beta (00000027)=0.132282492394931E+02 gamma(00000027)=0.132282492394931E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.17014E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 27 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000027)=0.000000000000000E+00 beta (00000028)=0.133734901870793E+02 gamma(00000028)=0.133734901870793E+02 lr_calc_dens: Charge drift due to real space implementation = 0.35093E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 28 z1= 1 -.266523201951351E+00 0.000000000000000E+00 z1= 2 0.140045320409675E-04 0.000000000000000E+00 z1= 3 0.758291682843767E-07 0.000000000000000E+00 alpha(00000028)=0.000000000000000E+00 beta (00000029)=0.131322684315959E+02 gamma(00000029)=0.131322684315959E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.95889E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 29 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000029)=0.000000000000000E+00 beta (00000030)=0.133470751400284E+02 gamma(00000030)=0.133470751400284E+02 lr_calc_dens: Charge drift due to real space implementation = -0.33067E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 30 z1= 1 0.253640770057783E+00 0.000000000000000E+00 z1= 2 -.138756670371828E-04 0.000000000000000E+00 z1= 3 -.356038451642776E-07 0.000000000000000E+00 alpha(00000030)=0.000000000000000E+00 beta (00000031)=0.131562964265876E+02 gamma(00000031)=0.131562964265876E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.39462E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 31 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000031)=0.000000000000000E+00 beta (00000032)=0.133986934864918E+02 gamma(00000032)=0.133986934864918E+02 lr_calc_dens: Charge drift due to real space implementation = 0.25395E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 32 z1= 1 -.241852543366192E+00 0.000000000000000E+00 z1= 2 0.119442069720747E-04 0.000000000000000E+00 z1= 3 0.632726711803469E-08 0.000000000000000E+00 alpha(00000032)=0.000000000000000E+00 beta (00000033)=0.131842834255282E+02 gamma(00000033)=0.131842834255282E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.54607E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 33 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000033)=0.000000000000000E+00 beta (00000034)=0.134133663782532E+02 gamma(00000034)=0.134133663782532E+02 lr_calc_dens: Charge drift due to real space implementation = -0.22172E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 34 z1= 1 0.231207512060255E+00 0.000000000000000E+00 z1= 2 -.100595610741157E-04 0.000000000000000E+00 z1= 3 -.171386757869497E-07 0.000000000000000E+00 alpha(00000034)=0.000000000000000E+00 beta (00000035)=0.131415428344981E+02 gamma(00000035)=0.131415428344981E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.59611E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 35 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000035)=0.000000000000000E+00 beta (00000036)=0.133543554314700E+02 gamma(00000036)=0.133543554314700E+02 lr_calc_dens: Charge drift due to real space implementation = 0.21319E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 36 z1= 1 -.220984524859984E+00 0.000000000000000E+00 z1= 2 0.870127634202767E-05 0.000000000000000E+00 z1= 3 0.609741693596191E-08 0.000000000000000E+00 alpha(00000036)=0.000000000000000E+00 beta (00000037)=0.130639299680321E+02 gamma(00000037)=0.130639299680321E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.48097E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 37 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000037)=0.000000000000000E+00 beta (00000038)=0.133660501507113E+02 gamma(00000038)=0.133660501507113E+02 lr_calc_dens: Charge drift due to real space implementation = -0.24132E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 38 z1= 1 0.209057217959415E+00 0.000000000000000E+00 z1= 2 -.793813281720936E-05 0.000000000000000E+00 z1= 3 0.624484534727362E-07 0.000000000000000E+00 alpha(00000038)=0.000000000000000E+00 beta (00000039)=0.131726878501112E+02 gamma(00000039)=0.131726878501112E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.23381E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 39 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000039)=0.000000000000000E+00 beta (00000040)=0.134143691150347E+02 gamma(00000040)=0.134143691150347E+02 lr_calc_dens: Charge drift due to real space implementation = 0.22856E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 40 z1= 1 -.197731177607841E+00 0.000000000000000E+00 z1= 2 0.726259008463877E-05 0.000000000000000E+00 z1= 3 -.919159883019541E-07 0.000000000000000E+00 alpha(00000040)=0.000000000000000E+00 beta (00000041)=0.130946802111121E+02 gamma(00000041)=0.130946802111121E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.66472E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 41 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000041)=0.000000000000000E+00 beta (00000042)=0.133128297751803E+02 gamma(00000042)=0.133128297751803E+02 lr_calc_dens: Charge drift due to real space implementation = -0.24276E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 42 z1= 1 0.186187257490386E+00 0.000000000000000E+00 z1= 2 -.656948785087916E-05 0.000000000000000E+00 z1= 3 0.402062965889326E-07 0.000000000000000E+00 alpha(00000042)=0.000000000000000E+00 beta (00000043)=0.131627324730591E+02 gamma(00000043)=0.131627324730591E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.14077E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 43 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000043)=0.000000000000000E+00 beta (00000044)=0.133719644805836E+02 gamma(00000044)=0.133719644805836E+02 lr_calc_dens: Charge drift due to real space implementation = 0.22702E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 44 z1= 1 -.174724615460687E+00 0.000000000000000E+00 z1= 2 0.465849058034918E-05 0.000000000000000E+00 z1= 3 -.703653802908791E-07 0.000000000000000E+00 alpha(00000044)=0.000000000000000E+00 beta (00000045)=0.131154487455111E+02 gamma(00000045)=0.131154487455111E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.18971E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 45 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000045)=0.000000000000000E+00 beta (00000046)=0.133603142254381E+02 gamma(00000046)=0.133603142254381E+02 lr_calc_dens: Charge drift due to real space implementation = -0.19830E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 46 z1= 1 0.162870162398004E+00 0.000000000000000E+00 z1= 2 -.258624786765062E-05 0.000000000000000E+00 z1= 3 0.191530470760136E-06 0.000000000000000E+00 alpha(00000046)=0.000000000000000E+00 beta (00000047)=0.131871573377363E+02 gamma(00000047)=0.131871573377363E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.19953E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 47 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000047)=0.000000000000000E+00 beta (00000048)=0.133543009176990E+02 gamma(00000048)=0.133543009176990E+02 lr_calc_dens: Charge drift due to real space implementation = 0.20984E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 48 z1= 1 -.152406630062474E+00 0.000000000000000E+00 z1= 2 0.132904973653217E-06 0.000000000000000E+00 z1= 3 -.204415083334774E-06 0.000000000000000E+00 alpha(00000048)=0.000000000000000E+00 beta (00000049)=0.131377485362835E+02 gamma(00000049)=0.131377485362835E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.26968E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 49 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000049)=0.000000000000000E+00 beta (00000050)=0.133903491719301E+02 gamma(00000050)=0.133903491719301E+02 lr_calc_dens: Charge drift due to real space implementation = -0.13001E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 50 z1= 1 0.141525487289812E+00 0.000000000000000E+00 z1= 2 0.114186714161163E-05 0.000000000000000E+00 z1= 3 0.146420206105190E-06 0.000000000000000E+00 alpha(00000050)=0.000000000000000E+00 beta (00000051)=0.131686192951693E+02 gamma(00000051)=0.131686192951693E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.25471E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 51 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000051)=0.000000000000000E+00 beta (00000052)=0.134078773907098E+02 gamma(00000052)=0.134078773907098E+02 lr_calc_dens: Charge drift due to real space implementation = 0.69432E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 52 z1= 1 -.131423004012731E+00 0.000000000000000E+00 z1= 2 -.270315037766838E-05 0.000000000000000E+00 z1= 3 -.123323709577645E-06 0.000000000000000E+00 alpha(00000052)=0.000000000000000E+00 beta (00000053)=0.131495743756012E+02 gamma(00000053)=0.131495743756012E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.21090E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 53 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000053)=0.000000000000000E+00 beta (00000054)=0.133456091594400E+02 gamma(00000054)=0.133456091594400E+02 lr_calc_dens: Charge drift due to real space implementation = -0.44503E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 54 z1= 1 0.122131368847155E+00 0.000000000000000E+00 z1= 2 0.287057743682435E-05 0.000000000000000E+00 z1= 3 0.802812188620734E-07 0.000000000000000E+00 alpha(00000054)=0.000000000000000E+00 beta (00000055)=0.131133537470956E+02 gamma(00000055)=0.131133537470956E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.18576E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 55 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000055)=0.000000000000000E+00 beta (00000056)=0.134251420422865E+02 gamma(00000056)=0.134251420422865E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10355E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 56 z1= 1 -.112307136722425E+00 0.000000000000000E+00 z1= 2 -.324776350925197E-05 0.000000000000000E+00 z1= 3 -.607325432779010E-07 0.000000000000000E+00 alpha(00000056)=0.000000000000000E+00 beta (00000057)=0.131002649668074E+02 gamma(00000057)=0.131002649668074E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13412E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 57 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000057)=0.000000000000000E+00 beta (00000058)=0.134228399555810E+02 gamma(00000058)=0.134228399555810E+02 lr_calc_dens: Charge drift due to real space implementation = -0.22660E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 58 z1= 1 0.102873949908952E+00 0.000000000000000E+00 z1= 2 0.477367813852235E-05 0.000000000000000E+00 z1= 3 0.929587592991779E-07 0.000000000000000E+00 alpha(00000058)=0.000000000000000E+00 beta (00000059)=0.130956308379128E+02 gamma(00000059)=0.130956308379128E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.13995E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 59 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000059)=0.000000000000000E+00 beta (00000060)=0.133377890737783E+02 gamma(00000060)=0.133377890737783E+02 lr_calc_dens: Charge drift due to real space implementation = -0.34207E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 60 z1= 1 -.943633453917211E-01 0.000000000000000E+00 z1= 2 -.525903087132337E-05 0.000000000000000E+00 z1= 3 -.146517993550513E-06 0.000000000000000E+00 alpha(00000060)=0.000000000000000E+00 beta (00000061)=0.131043227255095E+02 gamma(00000061)=0.131043227255095E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.80396E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 61 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000061)=0.000000000000000E+00 beta (00000062)=0.134698703217584E+02 gamma(00000062)=0.134698703217584E+02 lr_calc_dens: Charge drift due to real space implementation = 0.52728E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 62 z1= 1 0.855566393474319E-01 0.000000000000000E+00 z1= 2 0.640673911839196E-05 0.000000000000000E+00 z1= 3 0.243020748673487E-06 0.000000000000000E+00 alpha(00000062)=0.000000000000000E+00 beta (00000063)=0.130238604563687E+02 gamma(00000063)=0.130238604563687E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10686E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 63 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000063)=0.000000000000000E+00 beta (00000064)=0.134471094318010E+02 gamma(00000064)=0.134471094318010E+02 lr_calc_dens: Charge drift due to real space implementation = 0.23098E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 64 z1= 1 -.769774604685214E-01 0.000000000000000E+00 z1= 2 -.697690126875636E-05 0.000000000000000E+00 z1= 3 -.152403449420902E-06 0.000000000000000E+00 alpha(00000064)=0.000000000000000E+00 beta (00000065)=0.131381279875479E+02 gamma(00000065)=0.131381279875479E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.13207E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 65 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000065)=0.000000000000000E+00 beta (00000066)=0.133842409690815E+02 gamma(00000066)=0.133842409690815E+02 lr_calc_dens: Charge drift due to real space implementation = -0.78132E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 66 z1= 1 0.701144286659192E-01 0.000000000000000E+00 z1= 2 0.785848978910111E-05 0.000000000000000E+00 z1= 3 -.181446578849590E-06 0.000000000000000E+00 alpha(00000066)=0.000000000000000E+00 beta (00000067)=0.130727292257979E+02 gamma(00000067)=0.130727292257979E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.62287E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 67 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000067)=0.000000000000000E+00 beta (00000068)=0.134317651801550E+02 gamma(00000068)=0.134317651801550E+02 lr_calc_dens: Charge drift due to real space implementation = 0.79045E-11 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 68 z1= 1 -.632898272698659E-01 0.000000000000000E+00 z1= 2 -.744106539068978E-05 0.000000000000000E+00 z1= 3 0.476924124772718E-06 0.000000000000000E+00 alpha(00000068)=0.000000000000000E+00 beta (00000069)=0.130739260123543E+02 gamma(00000069)=0.130739260123543E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.30015E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 69 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000069)=0.000000000000000E+00 beta (00000070)=0.134978985757986E+02 gamma(00000070)=0.134978985757986E+02 lr_calc_dens: Charge drift due to real space implementation = 0.59346E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 70 z1= 1 0.568392147160595E-01 0.000000000000000E+00 z1= 2 0.783246731778445E-05 0.000000000000000E+00 z1= 3 -.524252478533680E-06 0.000000000000000E+00 alpha(00000070)=0.000000000000000E+00 beta (00000071)=0.130501531109888E+02 gamma(00000071)=0.130501531109888E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.99294E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 71 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000071)=0.000000000000000E+00 beta (00000072)=0.134058677351838E+02 gamma(00000072)=0.134058677351838E+02 lr_calc_dens: Charge drift due to real space implementation = 0.61972E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 72 z1= 1 -.513826176605782E-01 0.000000000000000E+00 z1= 2 -.836363373143273E-05 0.000000000000000E+00 z1= 3 0.393671898462380E-06 0.000000000000000E+00 alpha(00000072)=0.000000000000000E+00 beta (00000073)=0.130819684672115E+02 gamma(00000073)=0.130819684672115E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.41558E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 73 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000073)=0.000000000000000E+00 beta (00000074)=0.134149668060244E+02 gamma(00000074)=0.134149668060244E+02 lr_calc_dens: Charge drift due to real space implementation = -0.93287E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 74 z1= 1 0.466024931300235E-01 0.000000000000000E+00 z1= 2 0.782507468319663E-05 0.000000000000000E+00 z1= 3 -.128177857717450E-06 0.000000000000000E+00 alpha(00000074)=0.000000000000000E+00 beta (00000075)=0.130620764370897E+02 gamma(00000075)=0.130620764370897E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.78502E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 75 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000075)=0.000000000000000E+00 beta (00000076)=0.134908502241889E+02 gamma(00000076)=0.134908502241889E+02 lr_calc_dens: Charge drift due to real space implementation = -0.61781E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 76 z1= 1 -.418945222391993E-01 0.000000000000000E+00 z1= 2 -.782980264527403E-05 0.000000000000000E+00 z1= 3 -.218319145521980E-06 0.000000000000000E+00 alpha(00000076)=0.000000000000000E+00 beta (00000077)=0.130701610567083E+02 gamma(00000077)=0.130701610567083E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.91246E-10 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 77 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000077)=0.000000000000000E+00 beta (00000078)=0.134421846235406E+02 gamma(00000078)=0.134421846235406E+02 lr_calc_dens: Charge drift due to real space implementation = 0.14972E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 78 z1= 1 0.377406777260702E-01 0.000000000000000E+00 z1= 2 0.803015906701912E-05 0.000000000000000E+00 z1= 3 0.391155360216700E-06 0.000000000000000E+00 alpha(00000078)=0.000000000000000E+00 beta (00000079)=0.131002453041857E+02 gamma(00000079)=0.131002453041857E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.16697E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 79 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000079)=0.000000000000000E+00 beta (00000080)=0.135267639439113E+02 gamma(00000080)=0.135267639439113E+02 lr_calc_dens: Charge drift due to real space implementation = -0.17884E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 80 z1= 1 -.338259679610013E-01 0.000000000000000E+00 z1= 2 -.703680966982617E-05 0.000000000000000E+00 z1= 3 -.232503529943968E-06 0.000000000000000E+00 alpha(00000080)=0.000000000000000E+00 beta (00000081)=0.129818289383891E+02 gamma(00000081)=0.129818289383891E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.16747E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 81 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000081)=0.000000000000000E+00 beta (00000082)=0.135012443026570E+02 gamma(00000082)=0.135012443026570E+02 lr_calc_dens: Charge drift due to real space implementation = -0.70926E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 82 z1= 1 0.299337790976265E-01 0.000000000000000E+00 z1= 2 0.665746506537182E-05 0.000000000000000E+00 z1= 3 -.804893745856239E-07 0.000000000000000E+00 alpha(00000082)=0.000000000000000E+00 beta (00000083)=0.130659166787046E+02 gamma(00000083)=0.130659166787046E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10606E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 83 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000083)=0.000000000000000E+00 beta (00000084)=0.134469285112211E+02 gamma(00000084)=0.134469285112211E+02 lr_calc_dens: Charge drift due to real space implementation = 0.98175E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 84 z1= 1 -.265222964715015E-01 0.000000000000000E+00 z1= 2 -.615085212228930E-05 0.000000000000000E+00 z1= 3 0.385023859160398E-06 0.000000000000000E+00 alpha(00000084)=0.000000000000000E+00 beta (00000085)=0.130083496841139E+02 gamma(00000085)=0.130083496841139E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.17207E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 85 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000085)=0.000000000000000E+00 beta (00000086)=0.134701070477375E+02 gamma(00000086)=0.134701070477375E+02 lr_calc_dens: Charge drift due to real space implementation = -0.14076E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 86 z1= 1 0.231700683474053E-01 0.000000000000000E+00 z1= 2 0.545177318829471E-05 0.000000000000000E+00 z1= 3 -.597837436737555E-06 0.000000000000000E+00 alpha(00000086)=0.000000000000000E+00 beta (00000087)=0.130141502302599E+02 gamma(00000087)=0.130141502302599E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.53935E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 87 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000087)=0.000000000000000E+00 beta (00000088)=0.135749356781448E+02 gamma(00000088)=0.135749356781448E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11110E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 88 z1= 1 -.199766434134450E-01 0.000000000000000E+00 z1= 2 -.496642636061209E-05 0.000000000000000E+00 z1= 3 0.718248273814007E-06 0.000000000000000E+00 alpha(00000088)=0.000000000000000E+00 beta (00000089)=0.130292392482505E+02 gamma(00000089)=0.130292392482505E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.84994E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 89 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000089)=0.000000000000000E+00 beta (00000090)=0.136133713221775E+02 gamma(00000090)=0.136133713221775E+02 lr_calc_dens: Charge drift due to real space implementation = -0.61352E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 90 z1= 1 0.169991176238086E-01 0.000000000000000E+00 z1= 2 0.466677354307547E-05 0.000000000000000E+00 z1= 3 -.679313026896161E-06 0.000000000000000E+00 alpha(00000090)=0.000000000000000E+00 beta (00000091)=0.130043414035344E+02 gamma(00000091)=0.130043414035344E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.58576E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 91 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000091)=0.000000000000000E+00 beta (00000092)=0.135204949757158E+02 gamma(00000092)=0.135204949757158E+02 lr_calc_dens: Charge drift due to real space implementation = 0.93342E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 92 z1= 1 -.142637465525535E-01 0.000000000000000E+00 z1= 2 -.382474787746778E-05 0.000000000000000E+00 z1= 3 0.349329359472699E-06 0.000000000000000E+00 alpha(00000092)=0.000000000000000E+00 beta (00000093)=0.130029719162490E+02 gamma(00000093)=0.130029719162490E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.63467E-10 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 93 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000093)=0.000000000000000E+00 beta (00000094)=0.135419000218295E+02 gamma(00000094)=0.135419000218295E+02 lr_calc_dens: Charge drift due to real space implementation = -0.99033E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 94 z1= 1 0.116429039221589E-01 0.000000000000000E+00 z1= 2 0.311754790404198E-05 0.000000000000000E+00 z1= 3 0.787216485289250E-07 0.000000000000000E+00 alpha(00000094)=0.000000000000000E+00 beta (00000095)=0.129989698932837E+02 gamma(00000095)=0.129989698932837E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.87961E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 95 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000095)=0.000000000000000E+00 beta (00000096)=0.134733905128088E+02 gamma(00000096)=0.134733905128088E+02 lr_calc_dens: Charge drift due to real space implementation = -0.16414E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 96 z1= 1 -.926721452530839E-02 0.000000000000000E+00 z1= 2 -.265635372457586E-05 0.000000000000000E+00 z1= 3 -.504984039109451E-06 0.000000000000000E+00 alpha(00000096)=0.000000000000000E+00 beta (00000097)=0.130095417422566E+02 gamma(00000097)=0.130095417422566E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13310E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 97 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000097)=0.000000000000000E+00 beta (00000098)=0.134584500836410E+02 gamma(00000098)=0.134584500836410E+02 lr_calc_dens: Charge drift due to real space implementation = -0.16069E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 98 z1= 1 0.708907296643749E-02 0.000000000000000E+00 z1= 2 0.351588784410113E-05 0.000000000000000E+00 z1= 3 0.794957032359064E-06 0.000000000000000E+00 alpha(00000098)=0.000000000000000E+00 beta (00000099)=0.128783669067858E+02 gamma(00000099)=0.128783669067858E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.38736E-10 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 99 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000099)=0.000000000000000E+00 beta (00000100)=0.135213388307261E+02 gamma(00000100)=0.135213388307261E+02 lr_calc_dens: Charge drift due to real space implementation = 0.90699E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 100 z1= 1 -.488276034006919E-02 0.000000000000000E+00 z1= 2 -.240844558638958E-05 0.000000000000000E+00 z1= 3 -.869128625571807E-06 0.000000000000000E+00 alpha(00000100)=0.000000000000000E+00 beta (00000101)=0.129901599491847E+02 gamma(00000101)=0.129901599491847E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10183E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 101 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000101)=0.000000000000000E+00 beta (00000102)=0.134728096598076E+02 gamma(00000102)=0.134728096598076E+02 lr_calc_dens: Charge drift due to real space implementation = -0.25168E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 102 z1= 1 0.280434786163280E-02 0.000000000000000E+00 z1= 2 -.884386773800962E-07 0.000000000000000E+00 z1= 3 0.763073836983815E-06 0.000000000000000E+00 alpha(00000102)=0.000000000000000E+00 beta (00000103)=0.130814138389190E+02 gamma(00000103)=0.130814138389190E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.15514E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 103 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000103)=0.000000000000000E+00 beta (00000104)=0.135391237467559E+02 gamma(00000104)=0.135391237467559E+02 lr_calc_dens: Charge drift due to real space implementation = -0.13691E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 104 z1= 1 -.808351274382680E-03 0.000000000000000E+00 z1= 2 0.122889021948042E-05 0.000000000000000E+00 z1= 3 -.352196879518478E-06 0.000000000000000E+00 alpha(00000104)=0.000000000000000E+00 beta (00000105)=0.129851105419826E+02 gamma(00000105)=0.129851105419826E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12904E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 105 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000105)=0.000000000000000E+00 beta (00000106)=0.135568517035129E+02 gamma(00000106)=0.135568517035129E+02 lr_calc_dens: Charge drift due to real space implementation = 0.63776E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 106 z1= 1 -.109954920730575E-02 0.000000000000000E+00 z1= 2 -.115689098182303E-05 0.000000000000000E+00 z1= 3 -.141656011762274E-06 0.000000000000000E+00 alpha(00000106)=0.000000000000000E+00 beta (00000107)=0.130133443144488E+02 gamma(00000107)=0.130133443144488E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.79654E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 107 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000107)=0.000000000000000E+00 beta (00000108)=0.135799641387517E+02 gamma(00000108)=0.135799641387517E+02 lr_calc_dens: Charge drift due to real space implementation = 0.87813E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 108 z1= 1 0.287798584615324E-02 0.000000000000000E+00 z1= 2 0.845081817258449E-06 0.000000000000000E+00 z1= 3 0.618399141059723E-06 0.000000000000000E+00 alpha(00000108)=0.000000000000000E+00 beta (00000109)=0.129315685311337E+02 gamma(00000109)=0.129315685311337E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.28526E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 109 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000109)=0.000000000000000E+00 beta (00000110)=0.135778790786164E+02 gamma(00000110)=0.135778790786164E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10849E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 110 z1= 1 -.448431224091670E-02 0.000000000000000E+00 z1= 2 -.234920084986345E-05 0.000000000000000E+00 z1= 3 -.109767783713756E-05 0.000000000000000E+00 alpha(00000110)=0.000000000000000E+00 beta (00000111)=0.129867752390371E+02 gamma(00000111)=0.129867752390371E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.13086E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 111 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000111)=0.000000000000000E+00 beta (00000112)=0.135042783817456E+02 gamma(00000112)=0.135042783817456E+02 lr_calc_dens: Charge drift due to real space implementation = 0.41176E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 112 z1= 1 0.605293565503944E-02 0.000000000000000E+00 z1= 2 0.449782020793153E-05 0.000000000000000E+00 z1= 3 0.119549965713902E-05 0.000000000000000E+00 alpha(00000112)=0.000000000000000E+00 beta (00000113)=0.129592432007168E+02 gamma(00000113)=0.129592432007168E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.17015E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 113 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000113)=0.000000000000000E+00 beta (00000114)=0.134383381422303E+02 gamma(00000114)=0.134383381422303E+02 lr_calc_dens: Charge drift due to real space implementation = 0.50923E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 114 z1= 1 -.766668810164815E-02 0.000000000000000E+00 z1= 2 -.514856578696802E-05 0.000000000000000E+00 z1= 3 -.709362806297167E-06 0.000000000000000E+00 alpha(00000114)=0.000000000000000E+00 beta (00000115)=0.130797999666642E+02 gamma(00000115)=0.130797999666642E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.13127E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 115 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000115)=0.000000000000000E+00 beta (00000116)=0.134812310535770E+02 gamma(00000116)=0.134812310535770E+02 lr_calc_dens: Charge drift due to real space implementation = -0.94274E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 116 z1= 1 0.927392724139043E-02 0.000000000000000E+00 z1= 2 0.551394781565882E-05 0.000000000000000E+00 z1= 3 -.292056002848105E-06 0.000000000000000E+00 alpha(00000116)=0.000000000000000E+00 beta (00000117)=0.130168439631804E+02 gamma(00000117)=0.130168439631804E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.85487E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 117 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000117)=0.000000000000000E+00 beta (00000118)=0.135618419000999E+02 gamma(00000118)=0.135618419000999E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12615E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 118 z1= 1 -.106616167234538E-01 0.000000000000000E+00 z1= 2 -.564310660444191E-05 0.000000000000000E+00 z1= 3 0.165945640394199E-05 0.000000000000000E+00 alpha(00000118)=0.000000000000000E+00 beta (00000119)=0.130724427508397E+02 gamma(00000119)=0.130724427508397E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.35032E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 119 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000119)=0.000000000000000E+00 beta (00000120)=0.134954920866050E+02 gamma(00000120)=0.134954920866050E+02 lr_calc_dens: Charge drift due to real space implementation = 0.13875E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 120 z1= 1 0.119765515153682E-01 0.000000000000000E+00 z1= 2 0.558649219353519E-05 0.000000000000000E+00 z1= 3 -.332584633650702E-05 0.000000000000000E+00 alpha(00000120)=0.000000000000000E+00 beta (00000121)=0.129541492237933E+02 gamma(00000121)=0.129541492237933E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.35428E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 121 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000121)=0.000000000000000E+00 beta (00000122)=0.135754095521201E+02 gamma(00000122)=0.135754095521201E+02 lr_calc_dens: Charge drift due to real space implementation = -0.34425E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 122 z1= 1 -.129851399793844E-01 0.000000000000000E+00 z1= 2 -.548223903289700E-05 0.000000000000000E+00 z1= 3 0.494054022177151E-05 0.000000000000000E+00 alpha(00000122)=0.000000000000000E+00 beta (00000123)=0.129355315671714E+02 gamma(00000123)=0.129355315671714E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12965E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 123 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000123)=0.000000000000000E+00 beta (00000124)=0.135440857089726E+02 gamma(00000124)=0.135440857089726E+02 lr_calc_dens: Charge drift due to real space implementation = -0.79501E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 124 z1= 1 0.139379208166946E-01 0.000000000000000E+00 z1= 2 0.604902931299577E-05 0.000000000000000E+00 z1= 3 -.631701452378874E-05 0.000000000000000E+00 alpha(00000124)=0.000000000000000E+00 beta (00000125)=0.129388332537397E+02 gamma(00000125)=0.129388332537397E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.86801E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 125 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000125)=0.000000000000000E+00 beta (00000126)=0.135615641185515E+02 gamma(00000126)=0.135615641185515E+02 lr_calc_dens: Charge drift due to real space implementation = 0.13287E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 126 z1= 1 -.149035560037259E-01 0.000000000000000E+00 z1= 2 -.611903197647590E-05 0.000000000000000E+00 z1= 3 0.741035858854220E-05 0.000000000000000E+00 alpha(00000126)=0.000000000000000E+00 beta (00000127)=0.130367602658613E+02 gamma(00000127)=0.130367602658613E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.48603E-10 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 127 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000127)=0.000000000000000E+00 beta (00000128)=0.135592167084037E+02 gamma(00000128)=0.135592167084037E+02 lr_calc_dens: Charge drift due to real space implementation = -0.96733E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 128 z1= 1 0.160647585415583E-01 0.000000000000000E+00 z1= 2 0.669168236851550E-05 0.000000000000000E+00 z1= 3 -.786694163375082E-05 0.000000000000000E+00 alpha(00000128)=0.000000000000000E+00 beta (00000129)=0.129463310100772E+02 gamma(00000129)=0.129463310100772E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.74628E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 129 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000129)=0.000000000000000E+00 beta (00000130)=0.134998551346796E+02 gamma(00000130)=0.134998551346796E+02 lr_calc_dens: Charge drift due to real space implementation = -0.47010E-10 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 130 z1= 1 -.172136952799874E-01 0.000000000000000E+00 z1= 2 -.719682413589245E-05 0.000000000000000E+00 z1= 3 0.762759673530671E-05 0.000000000000000E+00 alpha(00000130)=0.000000000000000E+00 beta (00000131)=0.130828438306545E+02 gamma(00000131)=0.130828438306545E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.45810E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 131 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000131)=0.000000000000000E+00 beta (00000132)=0.135786159941788E+02 gamma(00000132)=0.135786159941788E+02 lr_calc_dens: Charge drift due to real space implementation = 0.59502E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 132 z1= 1 0.182916027736760E-01 0.000000000000000E+00 z1= 2 0.730564837083010E-05 0.000000000000000E+00 z1= 3 -.714457508923980E-05 0.000000000000000E+00 alpha(00000132)=0.000000000000000E+00 beta (00000133)=0.130528611455703E+02 gamma(00000133)=0.130528611455703E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.85594E-10 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 133 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000133)=0.000000000000000E+00 beta (00000134)=0.136182746949034E+02 gamma(00000134)=0.136182746949034E+02 lr_calc_dens: Charge drift due to real space implementation = -0.13536E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 134 z1= 1 -.190541210289928E-01 0.000000000000000E+00 z1= 2 -.801093342234216E-05 0.000000000000000E+00 z1= 3 0.611282516174131E-05 0.000000000000000E+00 alpha(00000134)=0.000000000000000E+00 beta (00000135)=0.129268901443008E+02 gamma(00000135)=0.129268901443008E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.24995E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 135 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000135)=0.000000000000000E+00 beta (00000136)=0.135035409765085E+02 gamma(00000136)=0.135035409765085E+02 lr_calc_dens: Charge drift due to real space implementation = -0.13512E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 136 z1= 1 0.196531322342476E-01 0.000000000000000E+00 z1= 2 0.803014525561398E-05 0.000000000000000E+00 z1= 3 -.433960782831936E-05 0.000000000000000E+00 alpha(00000136)=0.000000000000000E+00 beta (00000137)=0.128649347363059E+02 gamma(00000137)=0.128649347363059E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14563E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 137 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000137)=0.000000000000000E+00 beta (00000138)=0.135681662975772E+02 gamma(00000138)=0.135681662975772E+02 lr_calc_dens: Charge drift due to real space implementation = 0.29476E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 138 z1= 1 -.199481291592921E-01 0.000000000000000E+00 z1= 2 -.825283759480974E-05 0.000000000000000E+00 z1= 3 0.195571528423892E-05 0.000000000000000E+00 alpha(00000138)=0.000000000000000E+00 beta (00000139)=0.129326610045059E+02 gamma(00000139)=0.129326610045059E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.18380E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 139 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000139)=0.000000000000000E+00 beta (00000140)=0.136190709614367E+02 gamma(00000140)=0.136190709614367E+02 lr_calc_dens: Charge drift due to real space implementation = -0.58627E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 140 z1= 1 0.201602240294108E-01 0.000000000000000E+00 z1= 2 0.849232386001576E-05 0.000000000000000E+00 z1= 3 0.608889100060942E-06 0.000000000000000E+00 alpha(00000140)=0.000000000000000E+00 beta (00000141)=0.130320820697252E+02 gamma(00000141)=0.130320820697252E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.20848E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 141 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000141)=0.000000000000000E+00 beta (00000142)=0.135449730189064E+02 gamma(00000142)=0.135449730189064E+02 lr_calc_dens: Charge drift due to real space implementation = -0.16853E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 142 z1= 1 -.206702277132490E-01 0.000000000000000E+00 z1= 2 -.907454879771341E-05 0.000000000000000E+00 z1= 3 -.319787175404047E-05 0.000000000000000E+00 alpha(00000142)=0.000000000000000E+00 beta (00000143)=0.129380886058431E+02 gamma(00000143)=0.129380886058431E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.69535E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 143 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000143)=0.000000000000000E+00 beta (00000144)=0.134549657448913E+02 gamma(00000144)=0.134549657448913E+02 lr_calc_dens: Charge drift due to real space implementation = 0.13364E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 144 z1= 1 0.213435188914576E-01 0.000000000000000E+00 z1= 2 0.896718592550104E-05 0.000000000000000E+00 z1= 3 0.571571410556913E-05 0.000000000000000E+00 alpha(00000144)=0.000000000000000E+00 beta (00000145)=0.129326937934644E+02 gamma(00000145)=0.129326937934644E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12487E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 145 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000145)=0.000000000000000E+00 beta (00000146)=0.135946765001300E+02 gamma(00000146)=0.135946765001300E+02 lr_calc_dens: Charge drift due to real space implementation = 0.18717E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 146 z1= 1 -.218323746253385E-01 0.000000000000000E+00 z1= 2 -.884389546819755E-05 0.000000000000000E+00 z1= 3 -.806712230480516E-05 0.000000000000000E+00 alpha(00000146)=0.000000000000000E+00 beta (00000147)=0.129290919118715E+02 gamma(00000147)=0.129290919118715E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.69165E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 147 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000147)=0.000000000000000E+00 beta (00000148)=0.135749592993820E+02 gamma(00000148)=0.135749592993820E+02 lr_calc_dens: Charge drift due to real space implementation = -0.14455E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 148 z1= 1 0.223276345862675E-01 0.000000000000000E+00 z1= 2 0.923924576672237E-05 0.000000000000000E+00 z1= 3 0.102262934261631E-04 0.000000000000000E+00 alpha(00000148)=0.000000000000000E+00 beta (00000149)=0.129738565603687E+02 gamma(00000149)=0.129738565603687E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.22173E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 149 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000149)=0.000000000000000E+00 beta (00000150)=0.135177703824691E+02 gamma(00000150)=0.135177703824691E+02 lr_calc_dens: Charge drift due to real space implementation = -0.51891E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 150 z1= 1 -.228141747950238E-01 0.000000000000000E+00 z1= 2 -.932112574769141E-05 0.000000000000000E+00 z1= 3 -.117756426153202E-04 0.000000000000000E+00 alpha(00000150)=0.000000000000000E+00 beta (00000151)=0.129053336764746E+02 gamma(00000151)=0.129053336764746E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.17956E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 151 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000151)=0.000000000000000E+00 beta (00000152)=0.135720218547817E+02 gamma(00000152)=0.135720218547817E+02 lr_calc_dens: Charge drift due to real space implementation = 0.17514E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 152 z1= 1 0.228027742858553E-01 0.000000000000000E+00 z1= 2 0.100166428646763E-04 0.000000000000000E+00 z1= 3 0.125395878281609E-04 0.000000000000000E+00 alpha(00000152)=0.000000000000000E+00 beta (00000153)=0.130080431107086E+02 gamma(00000153)=0.130080431107086E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.49684E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 153 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000153)=0.000000000000000E+00 beta (00000154)=0.135720896278745E+02 gamma(00000154)=0.135720896278745E+02 lr_calc_dens: Charge drift due to real space implementation = -0.17576E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 154 z1= 1 -.227430539471947E-01 0.000000000000000E+00 z1= 2 -.117237927739107E-04 0.000000000000000E+00 z1= 3 -.128412925561198E-04 0.000000000000000E+00 alpha(00000154)=0.000000000000000E+00 beta (00000155)=0.130317310202874E+02 gamma(00000155)=0.130317310202874E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.84625E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 155 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000155)=0.000000000000000E+00 beta (00000156)=0.135125557384033E+02 gamma(00000156)=0.135125557384033E+02 lr_calc_dens: Charge drift due to real space implementation = 0.42837E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 156 z1= 1 0.226651522779514E-01 0.000000000000000E+00 z1= 2 0.108045837922189E-04 0.000000000000000E+00 z1= 3 0.128170631008115E-04 0.000000000000000E+00 alpha(00000156)=0.000000000000000E+00 beta (00000157)=0.130214355665358E+02 gamma(00000157)=0.130214355665358E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.11386E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 157 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000157)=0.000000000000000E+00 beta (00000158)=0.135798867353598E+02 gamma(00000158)=0.135798867353598E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10696E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 158 z1= 1 -.224595223705723E-01 0.000000000000000E+00 z1= 2 -.912712450170826E-05 0.000000000000000E+00 z1= 3 -.124102775254706E-04 0.000000000000000E+00 alpha(00000158)=0.000000000000000E+00 beta (00000159)=0.129659829305132E+02 gamma(00000159)=0.129659829305132E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.40915E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 159 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000159)=0.000000000000000E+00 beta (00000160)=0.134670093666387E+02 gamma(00000160)=0.134670093666387E+02 lr_calc_dens: Charge drift due to real space implementation = -0.18179E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 160 z1= 1 0.225197495043006E-01 0.000000000000000E+00 z1= 2 0.798283734901285E-05 0.000000000000000E+00 z1= 3 0.114376028673280E-04 0.000000000000000E+00 alpha(00000160)=0.000000000000000E+00 beta (00000161)=0.130054897612909E+02 gamma(00000161)=0.130054897612909E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.91376E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 161 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000161)=0.000000000000000E+00 beta (00000162)=0.135280417771955E+02 gamma(00000162)=0.135280417771955E+02 lr_calc_dens: Charge drift due to real space implementation = 0.16766E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 162 z1= 1 -.227550052201184E-01 0.000000000000000E+00 z1= 2 -.750412905868234E-05 0.000000000000000E+00 z1= 3 -.968492417458766E-05 0.000000000000000E+00 alpha(00000162)=0.000000000000000E+00 beta (00000163)=0.130360104074681E+02 gamma(00000163)=0.130360104074681E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.27728E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 163 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000163)=0.000000000000000E+00 beta (00000164)=0.135887587968584E+02 gamma(00000164)=0.135887587968584E+02 lr_calc_dens: Charge drift due to real space implementation = 0.57264E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 164 z1= 1 0.230775301579422E-01 0.000000000000000E+00 z1= 2 0.789371692407471E-05 0.000000000000000E+00 z1= 3 0.727761409921568E-05 0.000000000000000E+00 alpha(00000164)=0.000000000000000E+00 beta (00000165)=0.128785044538821E+02 gamma(00000165)=0.128785044538821E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.23642E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 165 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000165)=0.000000000000000E+00 beta (00000166)=0.135425250363915E+02 gamma(00000166)=0.135425250363915E+02 lr_calc_dens: Charge drift due to real space implementation = -0.21258E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 166 z1= 1 -.230858880005378E-01 0.000000000000000E+00 z1= 2 -.671071884829062E-05 0.000000000000000E+00 z1= 3 -.414765677239414E-05 0.000000000000000E+00 alpha(00000166)=0.000000000000000E+00 beta (00000167)=0.129295645624818E+02 gamma(00000167)=0.129295645624818E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.92493E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 167 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000167)=0.000000000000000E+00 beta (00000168)=0.135821553439093E+02 gamma(00000168)=0.135821553439093E+02 lr_calc_dens: Charge drift due to real space implementation = 0.27819E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 168 z1= 1 0.229246542413456E-01 0.000000000000000E+00 z1= 2 0.452023171914435E-05 0.000000000000000E+00 z1= 3 0.455873492751143E-06 0.000000000000000E+00 alpha(00000168)=0.000000000000000E+00 beta (00000169)=0.130313901520047E+02 gamma(00000169)=0.130313901520047E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14487E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 169 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000169)=0.000000000000000E+00 beta (00000170)=0.136053916165019E+02 gamma(00000170)=0.136053916165019E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11574E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 170 z1= 1 -.227640353540031E-01 0.000000000000000E+00 z1= 2 -.437066519903611E-05 0.000000000000000E+00 z1= 3 0.350264007134793E-05 0.000000000000000E+00 alpha(00000170)=0.000000000000000E+00 beta (00000171)=0.129848644785792E+02 gamma(00000171)=0.129848644785792E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.21101E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 171 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000171)=0.000000000000000E+00 beta (00000172)=0.135567430373219E+02 gamma(00000172)=0.135567430373219E+02 lr_calc_dens: Charge drift due to real space implementation = -0.82591E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 172 z1= 1 0.224766816274005E-01 0.000000000000000E+00 z1= 2 0.421309162058339E-05 0.000000000000000E+00 z1= 3 -.753749935739722E-05 0.000000000000000E+00 alpha(00000172)=0.000000000000000E+00 beta (00000173)=0.129812428600343E+02 gamma(00000173)=0.129812428600343E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.11485E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 173 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000173)=0.000000000000000E+00 beta (00000174)=0.135525032272672E+02 gamma(00000174)=0.135525032272672E+02 lr_calc_dens: Charge drift due to real space implementation = 0.20123E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 174 z1= 1 -.220959435667357E-01 0.000000000000000E+00 z1= 2 -.244280425659542E-05 0.000000000000000E+00 z1= 3 0.114981909793942E-04 0.000000000000000E+00 alpha(00000174)=0.000000000000000E+00 beta (00000175)=0.129572252160745E+02 gamma(00000175)=0.129572252160745E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.86886E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 175 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000175)=0.000000000000000E+00 beta (00000176)=0.135704777952788E+02 gamma(00000176)=0.135704777952788E+02 lr_calc_dens: Charge drift due to real space implementation = -0.14888E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 176 z1= 1 0.215709934524323E-01 0.000000000000000E+00 z1= 2 0.195822705450176E-05 0.000000000000000E+00 z1= 3 -.153679310481330E-04 0.000000000000000E+00 alpha(00000176)=0.000000000000000E+00 beta (00000177)=0.129387107729195E+02 gamma(00000177)=0.129387107729195E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.28224E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 177 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000177)=0.000000000000000E+00 beta (00000178)=0.135655839351094E+02 gamma(00000178)=0.135655839351094E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11323E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 178 z1= 1 -.209414912184084E-01 0.000000000000000E+00 z1= 2 -.154081799663003E-05 0.000000000000000E+00 z1= 3 0.192067181677194E-04 0.000000000000000E+00 alpha(00000178)=0.000000000000000E+00 beta (00000179)=0.129028367746501E+02 gamma(00000179)=0.129028367746501E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.19120E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 179 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000179)=0.000000000000000E+00 beta (00000180)=0.135436655171707E+02 gamma(00000180)=0.135436655171707E+02 lr_calc_dens: Charge drift due to real space implementation = 0.23695E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 180 z1= 1 0.202480280889439E-01 0.000000000000000E+00 z1= 2 0.912889072408191E-07 0.000000000000000E+00 z1= 3 -.226377281199097E-04 0.000000000000000E+00 alpha(00000180)=0.000000000000000E+00 beta (00000181)=0.128711088374381E+02 gamma(00000181)=0.128711088374381E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.27631E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 181 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000181)=0.000000000000000E+00 beta (00000182)=0.136783597193688E+02 gamma(00000182)=0.136783597193688E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11649E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 182 z1= 1 -.193046086426991E-01 0.000000000000000E+00 z1= 2 0.122868966844760E-05 0.000000000000000E+00 z1= 3 0.253831069835132E-04 0.000000000000000E+00 alpha(00000182)=0.000000000000000E+00 beta (00000183)=0.129642530942783E+02 gamma(00000183)=0.129642530942783E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.89670E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 183 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000183)=0.000000000000000E+00 beta (00000184)=0.135340809305881E+02 gamma(00000184)=0.135340809305881E+02 lr_calc_dens: Charge drift due to real space implementation = -0.19876E-10 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 184 z1= 1 0.186723735216545E-01 0.000000000000000E+00 z1= 2 -.190814100689204E-05 0.000000000000000E+00 z1= 3 -.283490187971738E-04 0.000000000000000E+00 alpha(00000184)=0.000000000000000E+00 beta (00000185)=0.129126655199616E+02 gamma(00000185)=0.129126655199616E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.57522E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 185 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000185)=0.000000000000000E+00 beta (00000186)=0.135597532195109E+02 gamma(00000186)=0.135597532195109E+02 lr_calc_dens: Charge drift due to real space implementation = 0.55556E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 186 z1= 1 -.179379094522273E-01 0.000000000000000E+00 z1= 2 0.196314810709149E-05 0.000000000000000E+00 z1= 3 0.307794677393399E-04 0.000000000000000E+00 alpha(00000186)=0.000000000000000E+00 beta (00000187)=0.128930268243089E+02 gamma(00000187)=0.128930268243089E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.11432E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 187 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000187)=0.000000000000000E+00 beta (00000188)=0.136735378687460E+02 gamma(00000188)=0.136735378687460E+02 lr_calc_dens: Charge drift due to real space implementation = -0.27248E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 188 z1= 1 0.170687325811916E-01 0.000000000000000E+00 z1= 2 -.181313277478664E-05 0.000000000000000E+00 z1= 3 -.324361540526096E-04 0.000000000000000E+00 alpha(00000188)=0.000000000000000E+00 beta (00000189)=0.129187614450615E+02 gamma(00000189)=0.129187614450615E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.57734E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 189 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000189)=0.000000000000000E+00 beta (00000190)=0.136129336807431E+02 gamma(00000190)=0.136129336807431E+02 lr_calc_dens: Charge drift due to real space implementation = -0.49132E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 190 z1= 1 -.163056825154541E-01 0.000000000000000E+00 z1= 2 0.347624018318289E-05 0.000000000000000E+00 z1= 3 0.339019395556676E-04 0.000000000000000E+00 alpha(00000190)=0.000000000000000E+00 beta (00000191)=0.129105769138719E+02 gamma(00000191)=0.129105769138719E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13673E-11 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 191 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000191)=0.000000000000000E+00 beta (00000192)=0.135918730323386E+02 gamma(00000192)=0.135918730323386E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11079E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 192 z1= 1 0.154915491533671E-01 0.000000000000000E+00 z1= 2 -.548244043863458E-05 0.000000000000000E+00 z1= 3 -.353287473970203E-04 0.000000000000000E+00 alpha(00000192)=0.000000000000000E+00 beta (00000193)=0.130213160714059E+02 gamma(00000193)=0.130213160714059E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.98859E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 193 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000193)=0.000000000000000E+00 beta (00000194)=0.136096474492620E+02 gamma(00000194)=0.136096474492620E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12978E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 194 z1= 1 -.146303094485209E-01 0.000000000000000E+00 z1= 2 0.788196098973088E-05 0.000000000000000E+00 z1= 3 0.369994887583491E-04 0.000000000000000E+00 alpha(00000194)=0.000000000000000E+00 beta (00000195)=0.129342279173493E+02 gamma(00000195)=0.129342279173493E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12519E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 195 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000195)=0.000000000000000E+00 beta (00000196)=0.134882315840278E+02 gamma(00000196)=0.134882315840278E+02 lr_calc_dens: Charge drift due to real space implementation = 0.13781E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 196 z1= 1 0.137118826093510E-01 0.000000000000000E+00 z1= 2 -.766473032394899E-05 0.000000000000000E+00 z1= 3 -.385126225346591E-04 0.000000000000000E+00 alpha(00000196)=0.000000000000000E+00 beta (00000197)=0.129037658498794E+02 gamma(00000197)=0.129037658498794E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.11041E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 197 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000197)=0.000000000000000E+00 beta (00000198)=0.136099121546539E+02 gamma(00000198)=0.136099121546539E+02 lr_calc_dens: Charge drift due to real space implementation = -0.74736E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 198 z1= 1 -.126598640001664E-01 0.000000000000000E+00 z1= 2 0.541431842829765E-05 0.000000000000000E+00 z1= 3 0.392406306588048E-04 0.000000000000000E+00 alpha(00000198)=0.000000000000000E+00 beta (00000199)=0.129765393093053E+02 gamma(00000199)=0.129765393093053E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.15631E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 199 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000199)=0.000000000000000E+00 beta (00000200)=0.135518369334412E+02 gamma(00000200)=0.135518369334412E+02 lr_calc_dens: Charge drift due to real space implementation = -0.15846E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 200 z1= 1 0.118441477478172E-01 0.000000000000000E+00 z1= 2 -.305523007157167E-05 0.000000000000000E+00 z1= 3 -.400957969838015E-04 0.000000000000000E+00 alpha(00000200)=0.000000000000000E+00 beta (00000201)=0.129743034558745E+02 gamma(00000201)=0.129743034558745E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14532E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 201 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000201)=0.000000000000000E+00 beta (00000202)=0.136416138656730E+02 gamma(00000202)=0.136416138656730E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10469E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 202 z1= 1 -.110945915489430E-01 0.000000000000000E+00 z1= 2 0.392533830543369E-05 0.000000000000000E+00 z1= 3 0.404022865374782E-04 0.000000000000000E+00 alpha(00000202)=0.000000000000000E+00 beta (00000203)=0.129326802108791E+02 gamma(00000203)=0.129326802108791E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.55976E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 203 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000203)=0.000000000000000E+00 beta (00000204)=0.136058827341333E+02 gamma(00000204)=0.136058827341333E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10940E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 204 z1= 1 0.104779898018592E-01 0.000000000000000E+00 z1= 2 -.617643614996867E-05 0.000000000000000E+00 z1= 3 -.400797758756355E-04 0.000000000000000E+00 alpha(00000204)=0.000000000000000E+00 beta (00000205)=0.129810885034623E+02 gamma(00000205)=0.129810885034623E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.25648E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 205 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000205)=0.000000000000000E+00 beta (00000206)=0.135587298007175E+02 gamma(00000206)=0.135587298007175E+02 lr_calc_dens: Charge drift due to real space implementation = 0.68936E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 206 z1= 1 -.101449198877303E-01 0.000000000000000E+00 z1= 2 0.703067090725585E-05 0.000000000000000E+00 z1= 3 0.390998281261933E-04 0.000000000000000E+00 alpha(00000206)=0.000000000000000E+00 beta (00000207)=0.129796252231147E+02 gamma(00000207)=0.129796252231147E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10194E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 207 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000207)=0.000000000000000E+00 beta (00000208)=0.135400732986125E+02 gamma(00000208)=0.135400732986125E+02 lr_calc_dens: Charge drift due to real space implementation = 0.55642E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 208 z1= 1 0.991731265810506E-02 0.000000000000000E+00 z1= 2 -.676014454624647E-05 0.000000000000000E+00 z1= 3 -.371342665063150E-04 0.000000000000000E+00 alpha(00000208)=0.000000000000000E+00 beta (00000209)=0.129649994084953E+02 gamma(00000209)=0.129649994084953E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.43570E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 209 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000209)=0.000000000000000E+00 beta (00000210)=0.135637341140052E+02 gamma(00000210)=0.135637341140052E+02 lr_calc_dens: Charge drift due to real space implementation = -0.84522E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 210 z1= 1 -.966516147330704E-02 0.000000000000000E+00 z1= 2 0.611958736079256E-05 0.000000000000000E+00 z1= 3 0.345102960284918E-04 0.000000000000000E+00 alpha(00000210)=0.000000000000000E+00 beta (00000211)=0.129435440662861E+02 gamma(00000211)=0.129435440662861E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.18085E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 211 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000211)=0.000000000000000E+00 beta (00000212)=0.134722284950803E+02 gamma(00000212)=0.134722284950803E+02 lr_calc_dens: Charge drift due to real space implementation = 0.86353E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 212 z1= 1 0.945303317135930E-02 0.000000000000000E+00 z1= 2 -.660035960633239E-05 0.000000000000000E+00 z1= 3 -.321420370784836E-04 0.000000000000000E+00 alpha(00000212)=0.000000000000000E+00 beta (00000213)=0.129124823515992E+02 gamma(00000213)=0.129124823515992E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10426E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 213 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000213)=0.000000000000000E+00 beta (00000214)=0.134320566254576E+02 gamma(00000214)=0.134320566254576E+02 lr_calc_dens: Charge drift due to real space implementation = -0.31978E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 214 z1= 1 -.918507413436319E-02 0.000000000000000E+00 z1= 2 0.740426188644474E-05 0.000000000000000E+00 z1= 3 0.299209566738418E-04 0.000000000000000E+00 alpha(00000214)=0.000000000000000E+00 beta (00000215)=0.129185530265483E+02 gamma(00000215)=0.129185530265483E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.15579E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 215 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000215)=0.000000000000000E+00 beta (00000216)=0.135930342611534E+02 gamma(00000216)=0.135930342611534E+02 lr_calc_dens: Charge drift due to real space implementation = -0.66950E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 216 z1= 1 0.877707326157764E-02 0.000000000000000E+00 z1= 2 -.616701756942385E-05 0.000000000000000E+00 z1= 3 -.276048489995495E-04 0.000000000000000E+00 alpha(00000216)=0.000000000000000E+00 beta (00000217)=0.129502302904536E+02 gamma(00000217)=0.129502302904536E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.95541E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 217 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000217)=0.000000000000000E+00 beta (00000218)=0.135167552768139E+02 gamma(00000218)=0.135167552768139E+02 lr_calc_dens: Charge drift due to real space implementation = 0.65927E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 218 z1= 1 -.846422045779420E-02 0.000000000000000E+00 z1= 2 0.340636583112501E-05 0.000000000000000E+00 z1= 3 0.258678212211995E-04 0.000000000000000E+00 alpha(00000218)=0.000000000000000E+00 beta (00000219)=0.130276072711211E+02 gamma(00000219)=0.130276072711211E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.48072E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 219 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000219)=0.000000000000000E+00 beta (00000220)=0.135033559771573E+02 gamma(00000220)=0.135033559771573E+02 lr_calc_dens: Charge drift due to real space implementation = 0.84740E-10 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 220 z1= 1 0.824168589101581E-02 0.000000000000000E+00 z1= 2 -.315611871195415E-05 0.000000000000000E+00 z1= 3 -.247589445370078E-04 0.000000000000000E+00 alpha(00000220)=0.000000000000000E+00 beta (00000221)=0.129947046183735E+02 gamma(00000221)=0.129947046183735E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14617E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 221 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000221)=0.000000000000000E+00 beta (00000222)=0.135945082232905E+02 gamma(00000222)=0.135945082232905E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12930E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 222 z1= 1 -.801546040145181E-02 0.000000000000000E+00 z1= 2 0.318275160789572E-05 0.000000000000000E+00 z1= 3 0.237495872770667E-04 0.000000000000000E+00 alpha(00000222)=0.000000000000000E+00 beta (00000223)=0.129973006036537E+02 gamma(00000223)=0.129973006036537E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.48570E-10 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 223 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000223)=0.000000000000000E+00 beta (00000224)=0.135194691390879E+02 gamma(00000224)=0.135194691390879E+02 lr_calc_dens: Charge drift due to real space implementation = -0.89501E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 224 z1= 1 0.784565774560866E-02 0.000000000000000E+00 z1= 2 -.340149053548559E-05 0.000000000000000E+00 z1= 3 -.233036327798260E-04 0.000000000000000E+00 alpha(00000224)=0.000000000000000E+00 beta (00000225)=0.130101117084020E+02 gamma(00000225)=0.130101117084020E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.81960E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 225 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000225)=0.000000000000000E+00 beta (00000226)=0.136439290845455E+02 gamma(00000226)=0.136439290845455E+02 lr_calc_dens: Charge drift due to real space implementation = -0.74571E-10 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 226 z1= 1 -.758695984666794E-02 0.000000000000000E+00 z1= 2 0.351263118971703E-05 0.000000000000000E+00 z1= 3 0.229985150869626E-04 0.000000000000000E+00 alpha(00000226)=0.000000000000000E+00 beta (00000227)=0.129634088436458E+02 gamma(00000227)=0.129634088436458E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.64745E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 227 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000227)=0.000000000000000E+00 beta (00000228)=0.135931431548293E+02 gamma(00000228)=0.135931431548293E+02 lr_calc_dens: Charge drift due to real space implementation = 0.31189E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 228 z1= 1 0.731092470183225E-02 0.000000000000000E+00 z1= 2 -.260712784284261E-05 0.000000000000000E+00 z1= 3 -.226439030704337E-04 0.000000000000000E+00 alpha(00000228)=0.000000000000000E+00 beta (00000229)=0.130520708453183E+02 gamma(00000229)=0.130520708453183E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.60858E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 229 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000229)=0.000000000000000E+00 beta (00000230)=0.135345685048262E+02 gamma(00000230)=0.135345685048262E+02 lr_calc_dens: Charge drift due to real space implementation = -0.42776E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 230 z1= 1 -.703234324160234E-02 0.000000000000000E+00 z1= 2 0.150751505728977E-05 0.000000000000000E+00 z1= 3 0.219307320168485E-04 0.000000000000000E+00 alpha(00000230)=0.000000000000000E+00 beta (00000231)=0.129637614705173E+02 gamma(00000231)=0.129637614705173E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.33305E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 231 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000231)=0.000000000000000E+00 beta (00000232)=0.135142221371641E+02 gamma(00000232)=0.135142221371641E+02 lr_calc_dens: Charge drift due to real space implementation = 0.45750E-10 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 232 z1= 1 0.657378316589406E-02 0.000000000000000E+00 z1= 2 -.166141904482490E-05 0.000000000000000E+00 z1= 3 -.203332491182173E-04 0.000000000000000E+00 alpha(00000232)=0.000000000000000E+00 beta (00000233)=0.129906038398937E+02 gamma(00000233)=0.129906038398937E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.73382E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 233 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000233)=0.000000000000000E+00 beta (00000234)=0.135883889378419E+02 gamma(00000234)=0.135883889378419E+02 lr_calc_dens: Charge drift due to real space implementation = -0.71047E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 234 z1= 1 -.602045594013889E-02 0.000000000000000E+00 z1= 2 0.421650640682406E-06 0.000000000000000E+00 z1= 3 0.184520676027933E-04 0.000000000000000E+00 alpha(00000234)=0.000000000000000E+00 beta (00000235)=0.130301331289175E+02 gamma(00000235)=0.130301331289175E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.34018E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 235 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000235)=0.000000000000000E+00 beta (00000236)=0.134986375179581E+02 gamma(00000236)=0.134986375179581E+02 lr_calc_dens: Charge drift due to real space implementation = 0.15384E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 236 z1= 1 0.549438638717028E-02 0.000000000000000E+00 z1= 2 0.996783034392171E-06 0.000000000000000E+00 z1= 3 -.167263448535219E-04 0.000000000000000E+00 alpha(00000236)=0.000000000000000E+00 beta (00000237)=0.128881395018729E+02 gamma(00000237)=0.128881395018729E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13524E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 237 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000237)=0.000000000000000E+00 beta (00000238)=0.136129111576229E+02 gamma(00000238)=0.136129111576229E+02 lr_calc_dens: Charge drift due to real space implementation = -0.70496E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 238 z1= 1 -.492970010179364E-02 0.000000000000000E+00 z1= 2 -.306973182454245E-05 0.000000000000000E+00 z1= 3 0.149451432557837E-04 0.000000000000000E+00 alpha(00000238)=0.000000000000000E+00 beta (00000239)=0.130687243902810E+02 gamma(00000239)=0.130687243902810E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.22836E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 239 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000239)=0.000000000000000E+00 beta (00000240)=0.134727385384070E+02 gamma(00000240)=0.134727385384070E+02 lr_calc_dens: Charge drift due to real space implementation = -0.80704E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 240 z1= 1 0.461911919487919E-02 0.000000000000000E+00 z1= 2 0.480368989274477E-05 0.000000000000000E+00 z1= 3 -.139037423723145E-04 0.000000000000000E+00 alpha(00000240)=0.000000000000000E+00 beta (00000241)=0.130010315001044E+02 gamma(00000241)=0.130010315001044E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.15871E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 241 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000241)=0.000000000000000E+00 beta (00000242)=0.135065246531360E+02 gamma(00000242)=0.135065246531360E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12332E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 242 z1= 1 -.423734902755947E-02 0.000000000000000E+00 z1= 2 -.488973106607541E-05 0.000000000000000E+00 z1= 3 0.128413134554135E-04 0.000000000000000E+00 alpha(00000242)=0.000000000000000E+00 beta (00000243)=0.129338644033073E+02 gamma(00000243)=0.129338644033073E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.67789E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 243 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000243)=0.000000000000000E+00 beta (00000244)=0.134894151018274E+02 gamma(00000244)=0.134894151018274E+02 lr_calc_dens: Charge drift due to real space implementation = -0.97411E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 244 z1= 1 0.378362987187600E-02 0.000000000000000E+00 z1= 2 0.537029089154890E-05 0.000000000000000E+00 z1= 3 -.114309275905210E-04 0.000000000000000E+00 alpha(00000244)=0.000000000000000E+00 beta (00000245)=0.129529887802945E+02 gamma(00000245)=0.129529887802945E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.17261E-10 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 245 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000245)=0.000000000000000E+00 beta (00000246)=0.135766058805495E+02 gamma(00000246)=0.135766058805495E+02 lr_calc_dens: Charge drift due to real space implementation = 0.31996E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 246 z1= 1 -.333384506995551E-02 0.000000000000000E+00 z1= 2 -.475343131348376E-05 0.000000000000000E+00 z1= 3 0.957581403080539E-05 0.000000000000000E+00 alpha(00000246)=0.000000000000000E+00 beta (00000247)=0.129696962096304E+02 gamma(00000247)=0.129696962096304E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12621E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 247 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000247)=0.000000000000000E+00 beta (00000248)=0.135063234311811E+02 gamma(00000248)=0.135063234311811E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12729E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 248 z1= 1 0.293154843233674E-02 0.000000000000000E+00 z1= 2 0.480412613765302E-05 0.000000000000000E+00 z1= 3 -.790068912095670E-05 0.000000000000000E+00 alpha(00000248)=0.000000000000000E+00 beta (00000249)=0.130314877676118E+02 gamma(00000249)=0.130314877676118E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.41144E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 249 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000249)=0.000000000000000E+00 beta (00000250)=0.135095511261476E+02 gamma(00000250)=0.135095511261476E+02 lr_calc_dens: Charge drift due to real space implementation = 0.60322E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 250 z1= 1 -.253169340566534E-02 0.000000000000000E+00 z1= 2 -.337606019540446E-05 0.000000000000000E+00 z1= 3 0.676188155619234E-05 0.000000000000000E+00 alpha(00000250)=0.000000000000000E+00 beta (00000251)=0.129617315817255E+02 gamma(00000251)=0.129617315817255E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.86515E-11 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 251 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000251)=0.000000000000000E+00 beta (00000252)=0.134739868260769E+02 gamma(00000252)=0.134739868260769E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11825E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 252 z1= 1 0.204134685238770E-02 0.000000000000000E+00 z1= 2 0.201096898469477E-05 0.000000000000000E+00 z1= 3 -.615387794055978E-05 0.000000000000000E+00 alpha(00000252)=0.000000000000000E+00 beta (00000253)=0.128790334132099E+02 gamma(00000253)=0.128790334132099E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.14850E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 253 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000253)=0.000000000000000E+00 beta (00000254)=0.135029234517563E+02 gamma(00000254)=0.135029234517563E+02 lr_calc_dens: Charge drift due to real space implementation = -0.13478E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 254 z1= 1 -.145506008518045E-02 0.000000000000000E+00 z1= 2 -.272457394422283E-05 0.000000000000000E+00 z1= 3 0.605539439529489E-05 0.000000000000000E+00 alpha(00000254)=0.000000000000000E+00 beta (00000255)=0.130119305640898E+02 gamma(00000255)=0.130119305640898E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13461E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 255 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000255)=0.000000000000000E+00 beta (00000256)=0.135424775347603E+02 gamma(00000256)=0.135424775347603E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12504E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 256 z1= 1 0.941908131715763E-03 0.000000000000000E+00 z1= 2 0.505622452596881E-05 0.000000000000000E+00 z1= 3 -.662933454060096E-05 0.000000000000000E+00 alpha(00000256)=0.000000000000000E+00 beta (00000257)=0.129453463526845E+02 gamma(00000257)=0.129453463526845E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13122E-10 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 257 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000257)=0.000000000000000E+00 beta (00000258)=0.135522560038091E+02 gamma(00000258)=0.135522560038091E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10679E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 258 z1= 1 -.490116644418192E-03 0.000000000000000E+00 z1= 2 -.543585704734957E-05 0.000000000000000E+00 z1= 3 0.792853378130909E-05 0.000000000000000E+00 alpha(00000258)=0.000000000000000E+00 beta (00000259)=0.129698610225265E+02 gamma(00000259)=0.129698610225265E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.14038E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 259 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000259)=0.000000000000000E+00 beta (00000260)=0.135681150529139E+02 gamma(00000260)=0.135681150529139E+02 lr_calc_dens: Charge drift due to real space implementation = -0.87684E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 260 z1= 1 0.148017404009212E-03 0.000000000000000E+00 z1= 2 0.460922838179875E-05 0.000000000000000E+00 z1= 3 -.979693829866642E-05 0.000000000000000E+00 alpha(00000260)=0.000000000000000E+00 beta (00000261)=0.129625056301998E+02 gamma(00000261)=0.129625056301998E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.41408E-10 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 261 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000261)=0.000000000000000E+00 beta (00000262)=0.135315199001121E+02 gamma(00000262)=0.135315199001121E+02 lr_calc_dens: Charge drift due to real space implementation = 0.32569E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 262 z1= 1 0.112431021591722E-03 0.000000000000000E+00 z1= 2 -.487161144153633E-05 0.000000000000000E+00 z1= 3 0.119834517807079E-04 0.000000000000000E+00 alpha(00000262)=0.000000000000000E+00 beta (00000263)=0.129494513108761E+02 gamma(00000263)=0.129494513108761E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.54075E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 263 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000263)=0.000000000000000E+00 beta (00000264)=0.135652470792282E+02 gamma(00000264)=0.135652470792282E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10970E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 264 z1= 1 -.349028665259213E-03 0.000000000000000E+00 z1= 2 0.553212339281673E-05 0.000000000000000E+00 z1= 3 -.140699845827101E-04 0.000000000000000E+00 alpha(00000264)=0.000000000000000E+00 beta (00000265)=0.130656999565060E+02 gamma(00000265)=0.130656999565060E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10447E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 265 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000265)=0.000000000000000E+00 beta (00000266)=0.134848840067500E+02 gamma(00000266)=0.134848840067500E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12273E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 266 z1= 1 0.510656059510657E-03 0.000000000000000E+00 z1= 2 -.470357326150684E-05 0.000000000000000E+00 z1= 3 0.159400161904185E-04 0.000000000000000E+00 alpha(00000266)=0.000000000000000E+00 beta (00000267)=0.129924397405171E+02 gamma(00000267)=0.129924397405171E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10642E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 267 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000267)=0.000000000000000E+00 beta (00000268)=0.135438201164906E+02 gamma(00000268)=0.135438201164906E+02 lr_calc_dens: Charge drift due to real space implementation = -0.66657E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 268 z1= 1 -.639896327995012E-03 0.000000000000000E+00 z1= 2 0.537410027320667E-05 0.000000000000000E+00 z1= 3 -.169957758406712E-04 0.000000000000000E+00 alpha(00000268)=0.000000000000000E+00 beta (00000269)=0.129839068487959E+02 gamma(00000269)=0.129839068487959E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.21300E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 269 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000269)=0.000000000000000E+00 beta (00000270)=0.135931460802547E+02 gamma(00000270)=0.135931460802547E+02 lr_calc_dens: Charge drift due to real space implementation = 0.42444E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 270 z1= 1 0.853935079623238E-03 0.000000000000000E+00 z1= 2 -.724917221009945E-05 0.000000000000000E+00 z1= 3 0.174471132084666E-04 0.000000000000000E+00 alpha(00000270)=0.000000000000000E+00 beta (00000271)=0.129826795864489E+02 gamma(00000271)=0.129826795864489E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.54976E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 271 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000271)=0.000000000000000E+00 beta (00000272)=0.135369525011909E+02 gamma(00000272)=0.135369525011909E+02 lr_calc_dens: Charge drift due to real space implementation = 0.91554E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 272 z1= 1 -.114896335238850E-02 0.000000000000000E+00 z1= 2 0.940299048193816E-05 0.000000000000000E+00 z1= 3 -.180240748940504E-04 0.000000000000000E+00 alpha(00000272)=0.000000000000000E+00 beta (00000273)=0.130092504346104E+02 gamma(00000273)=0.130092504346104E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.73756E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 273 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000273)=0.000000000000000E+00 beta (00000274)=0.134678130035344E+02 gamma(00000274)=0.134678130035344E+02 lr_calc_dens: Charge drift due to real space implementation = -0.17090E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 274 z1= 1 0.152923097202456E-02 0.000000000000000E+00 z1= 2 -.111519313048410E-04 0.000000000000000E+00 z1= 3 0.188849512872001E-04 0.000000000000000E+00 alpha(00000274)=0.000000000000000E+00 beta (00000275)=0.128713915995054E+02 gamma(00000275)=0.128713915995054E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.71206E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 275 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000275)=0.000000000000000E+00 beta (00000276)=0.135657705783171E+02 gamma(00000276)=0.135657705783171E+02 lr_calc_dens: Charge drift due to real space implementation = -0.24947E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 276 z1= 1 -.181828010852088E-02 0.000000000000000E+00 z1= 2 0.124149149071961E-04 0.000000000000000E+00 z1= 3 -.195855766426865E-04 0.000000000000000E+00 alpha(00000276)=0.000000000000000E+00 beta (00000277)=0.130593992786079E+02 gamma(00000277)=0.130593992786079E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.39361E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 277 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000277)=0.000000000000000E+00 beta (00000278)=0.134944065457439E+02 gamma(00000278)=0.134944065457439E+02 lr_calc_dens: Charge drift due to real space implementation = 0.35854E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 278 z1= 1 0.192583092580986E-02 0.000000000000000E+00 z1= 2 -.138235969811915E-04 0.000000000000000E+00 z1= 3 0.208797414218929E-04 0.000000000000000E+00 alpha(00000278)=0.000000000000000E+00 beta (00000279)=0.130992716942884E+02 gamma(00000279)=0.130992716942884E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.17001E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 279 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000279)=0.000000000000000E+00 beta (00000280)=0.135807962553580E+02 gamma(00000280)=0.135807962553580E+02 lr_calc_dens: Charge drift due to real space implementation = -0.57519E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 280 z1= 1 -.182404785337975E-02 0.000000000000000E+00 z1= 2 0.131882284697933E-04 0.000000000000000E+00 z1= 3 -.221751717541468E-04 0.000000000000000E+00 alpha(00000280)=0.000000000000000E+00 beta (00000281)=0.129724421553745E+02 gamma(00000281)=0.129724421553745E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.63447E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 281 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000281)=0.000000000000000E+00 beta (00000282)=0.135791676891513E+02 gamma(00000282)=0.135791676891513E+02 lr_calc_dens: Charge drift due to real space implementation = -0.44191E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 282 z1= 1 0.173691921362541E-02 0.000000000000000E+00 z1= 2 -.124817381710130E-04 0.000000000000000E+00 z1= 3 0.234611682944691E-04 0.000000000000000E+00 alpha(00000282)=0.000000000000000E+00 beta (00000283)=0.129997401479538E+02 gamma(00000283)=0.129997401479538E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10097E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 283 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000283)=0.000000000000000E+00 beta (00000284)=0.134797336861853E+02 gamma(00000284)=0.134797336861853E+02 lr_calc_dens: Charge drift due to real space implementation = 0.51104E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 284 z1= 1 -.176211822533431E-02 0.000000000000000E+00 z1= 2 0.132546620225998E-04 0.000000000000000E+00 z1= 3 -.251739965659734E-04 0.000000000000000E+00 alpha(00000284)=0.000000000000000E+00 beta (00000285)=0.129337694758820E+02 gamma(00000285)=0.129337694758820E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.54328E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 285 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000285)=0.000000000000000E+00 beta (00000286)=0.135791793625913E+02 gamma(00000286)=0.135791793625913E+02 lr_calc_dens: Charge drift due to real space implementation = -0.68099E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 286 z1= 1 0.171412685371960E-02 0.000000000000000E+00 z1= 2 -.141806677007592E-04 0.000000000000000E+00 z1= 3 0.267455971019423E-04 0.000000000000000E+00 alpha(00000286)=0.000000000000000E+00 beta (00000287)=0.129530649212429E+02 gamma(00000287)=0.129530649212429E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.14021E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 287 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000287)=0.000000000000000E+00 beta (00000288)=0.135141864550206E+02 gamma(00000288)=0.135141864550206E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10451E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 288 z1= 1 -.154958140818874E-02 0.000000000000000E+00 z1= 2 0.146415178260517E-04 0.000000000000000E+00 z1= 3 -.290705148127235E-04 0.000000000000000E+00 alpha(00000288)=0.000000000000000E+00 beta (00000289)=0.130608264370402E+02 gamma(00000289)=0.130608264370402E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13845E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 289 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000289)=0.000000000000000E+00 beta (00000290)=0.135016107373164E+02 gamma(00000290)=0.135016107373164E+02 lr_calc_dens: Charge drift due to real space implementation = 0.64812E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 290 z1= 1 0.118222312947158E-02 0.000000000000000E+00 z1= 2 -.156772651012439E-04 0.000000000000000E+00 z1= 3 0.319025407366513E-04 0.000000000000000E+00 alpha(00000290)=0.000000000000000E+00 beta (00000291)=0.129585780171974E+02 gamma(00000291)=0.129585780171974E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.92581E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 291 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000291)=0.000000000000000E+00 beta (00000292)=0.135079021652254E+02 gamma(00000292)=0.135079021652254E+02 lr_calc_dens: Charge drift due to real space implementation = -0.65619E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 292 z1= 1 -.672376930392359E-03 0.000000000000000E+00 z1= 2 0.162393465934592E-04 0.000000000000000E+00 z1= 3 -.343462068153396E-04 0.000000000000000E+00 alpha(00000292)=0.000000000000000E+00 beta (00000293)=0.129577728590701E+02 gamma(00000293)=0.129577728590701E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.42853E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 293 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000293)=0.000000000000000E+00 beta (00000294)=0.135448193050201E+02 gamma(00000294)=0.135448193050201E+02 lr_calc_dens: Charge drift due to real space implementation = 0.50503E-10 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 294 z1= 1 0.244549981446876E-03 0.000000000000000E+00 z1= 2 -.147322990961670E-04 0.000000000000000E+00 z1= 3 0.366182727871263E-04 0.000000000000000E+00 alpha(00000294)=0.000000000000000E+00 beta (00000295)=0.129671223350477E+02 gamma(00000295)=0.129671223350477E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.74838E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 295 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000295)=0.000000000000000E+00 beta (00000296)=0.134289470043153E+02 gamma(00000296)=0.134289470043153E+02 lr_calc_dens: Charge drift due to real space implementation = -0.25115E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 296 z1= 1 -.261965348963269E-04 0.000000000000000E+00 z1= 2 0.126424053051750E-04 0.000000000000000E+00 z1= 3 -.394583345680748E-04 0.000000000000000E+00 alpha(00000296)=0.000000000000000E+00 beta (00000297)=0.130486405990199E+02 gamma(00000297)=0.130486405990199E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.38378E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 297 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000297)=0.000000000000000E+00 beta (00000298)=0.134740306023102E+02 gamma(00000298)=0.134740306023102E+02 lr_calc_dens: Charge drift due to real space implementation = -0.85723E-10 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 298 z1= 1 0.319644088600862E-04 0.000000000000000E+00 z1= 2 -.112419001905961E-04 0.000000000000000E+00 z1= 3 0.425670796167709E-04 0.000000000000000E+00 alpha(00000298)=0.000000000000000E+00 beta (00000299)=0.129777718699460E+02 gamma(00000299)=0.129777718699460E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.71895E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 299 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000299)=0.000000000000000E+00 beta (00000300)=0.135462017810993E+02 gamma(00000300)=0.135462017810993E+02 lr_calc_dens: Charge drift due to real space implementation = 0.74670E-10 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 300 z1= 1 -.237495007092200E-03 0.000000000000000E+00 z1= 2 0.106683885244254E-04 0.000000000000000E+00 z1= 3 -.451380673260244E-04 0.000000000000000E+00 alpha(00000300)=0.000000000000000E+00 beta (00000301)=0.129831406036560E+02 gamma(00000301)=0.129831406036560E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13543E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 301 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000301)=0.000000000000000E+00 beta (00000302)=0.134463612802829E+02 gamma(00000302)=0.134463612802829E+02 lr_calc_dens: Charge drift due to real space implementation = 0.77526E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 302 z1= 1 0.608572796962529E-03 0.000000000000000E+00 z1= 2 -.117579381254109E-04 0.000000000000000E+00 z1= 3 0.475579252598626E-04 0.000000000000000E+00 alpha(00000302)=0.000000000000000E+00 beta (00000303)=0.130847077311555E+02 gamma(00000303)=0.130847077311555E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.64488E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 303 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000303)=0.000000000000000E+00 beta (00000304)=0.135191348261631E+02 gamma(00000304)=0.135191348261631E+02 lr_calc_dens: Charge drift due to real space implementation = -0.47535E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 304 z1= 1 -.113075282023537E-02 0.000000000000000E+00 z1= 2 0.129060226189527E-04 0.000000000000000E+00 z1= 3 -.492466494156729E-04 0.000000000000000E+00 alpha(00000304)=0.000000000000000E+00 beta (00000305)=0.130079140361421E+02 gamma(00000305)=0.130079140361421E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.26159E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 305 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000305)=0.000000000000000E+00 beta (00000306)=0.134782206324991E+02 gamma(00000306)=0.134782206324991E+02 lr_calc_dens: Charge drift due to real space implementation = -0.26979E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 306 z1= 1 0.173020118777862E-02 0.000000000000000E+00 z1= 2 -.117893744014819E-04 0.000000000000000E+00 z1= 3 0.500430753714395E-04 0.000000000000000E+00 alpha(00000306)=0.000000000000000E+00 beta (00000307)=0.130474698240792E+02 gamma(00000307)=0.130474698240792E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10585E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 307 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000307)=0.000000000000000E+00 beta (00000308)=0.135213233428099E+02 gamma(00000308)=0.135213233428099E+02 lr_calc_dens: Charge drift due to real space implementation = -0.37681E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 308 z1= 1 -.221203542716323E-02 0.000000000000000E+00 z1= 2 0.913528782029837E-05 0.000000000000000E+00 z1= 3 -.505738919513514E-04 0.000000000000000E+00 alpha(00000308)=0.000000000000000E+00 beta (00000309)=0.128979372126674E+02 gamma(00000309)=0.128979372126674E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13399E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 309 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000309)=0.000000000000000E+00 beta (00000310)=0.133945225506403E+02 gamma(00000310)=0.133945225506403E+02 lr_calc_dens: Charge drift due to real space implementation = 0.19092E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 310 z1= 1 0.253227100808269E-02 0.000000000000000E+00 z1= 2 -.576006557771042E-05 0.000000000000000E+00 z1= 3 0.506482023746407E-04 0.000000000000000E+00 alpha(00000310)=0.000000000000000E+00 beta (00000311)=0.130862050323704E+02 gamma(00000311)=0.130862050323704E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.43491E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 311 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000311)=0.000000000000000E+00 beta (00000312)=0.134962326408180E+02 gamma(00000312)=0.134962326408180E+02 lr_calc_dens: Charge drift due to real space implementation = -0.13368E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 312 z1= 1 -.283585426539241E-02 0.000000000000000E+00 z1= 2 0.400790350843679E-05 0.000000000000000E+00 z1= 3 -.505727153115515E-04 0.000000000000000E+00 alpha(00000312)=0.000000000000000E+00 beta (00000313)=0.130259945347565E+02 gamma(00000313)=0.130259945347565E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.15937E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 313 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000313)=0.000000000000000E+00 beta (00000314)=0.135524229464118E+02 gamma(00000314)=0.135524229464118E+02 lr_calc_dens: Charge drift due to real space implementation = -0.33620E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 314 z1= 1 0.326185777692436E-02 0.000000000000000E+00 z1= 2 -.248502369934196E-05 0.000000000000000E+00 z1= 3 0.500919593197652E-04 0.000000000000000E+00 alpha(00000314)=0.000000000000000E+00 beta (00000315)=0.130435747550953E+02 gamma(00000315)=0.130435747550953E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12642E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 315 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000315)=0.000000000000000E+00 beta (00000316)=0.134312286914891E+02 gamma(00000316)=0.134312286914891E+02 lr_calc_dens: Charge drift due to real space implementation = 0.18767E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 316 z1= 1 -.392587044083897E-02 0.000000000000000E+00 z1= 2 -.634817721072503E-06 0.000000000000000E+00 z1= 3 -.501953736128849E-04 0.000000000000000E+00 alpha(00000316)=0.000000000000000E+00 beta (00000317)=0.130692418785823E+02 gamma(00000317)=0.130692418785823E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.81312E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 317 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000317)=0.000000000000000E+00 beta (00000318)=0.134046550570396E+02 gamma(00000318)=0.134046550570396E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11346E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 318 z1= 1 0.468399586611440E-02 0.000000000000000E+00 z1= 2 0.422788368708519E-05 0.000000000000000E+00 z1= 3 0.504184901468187E-04 0.000000000000000E+00 alpha(00000318)=0.000000000000000E+00 beta (00000319)=0.130359989701853E+02 gamma(00000319)=0.130359989701853E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.16025E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 319 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000319)=0.000000000000000E+00 beta (00000320)=0.134984495822780E+02 gamma(00000320)=0.134984495822780E+02 lr_calc_dens: Charge drift due to real space implementation = 0.19317E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 320 z1= 1 -.523572549181978E-02 0.000000000000000E+00 z1= 2 -.821227764863592E-05 0.000000000000000E+00 z1= 3 -.503999197017036E-04 0.000000000000000E+00 alpha(00000320)=0.000000000000000E+00 beta (00000321)=0.130324455209427E+02 gamma(00000321)=0.130324455209427E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.18057E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 321 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000321)=0.000000000000000E+00 beta (00000322)=0.136111430030506E+02 gamma(00000322)=0.136111430030506E+02 lr_calc_dens: Charge drift due to real space implementation = 0.75789E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 322 z1= 1 0.556783282037775E-02 0.000000000000000E+00 z1= 2 0.103083582707951E-04 0.000000000000000E+00 z1= 3 0.501468079267149E-04 0.000000000000000E+00 alpha(00000322)=0.000000000000000E+00 beta (00000323)=0.130148813088068E+02 gamma(00000323)=0.130148813088068E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.16344E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 323 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000323)=0.000000000000000E+00 beta (00000324)=0.134276488227855E+02 gamma(00000324)=0.134276488227855E+02 lr_calc_dens: Charge drift due to real space implementation = -0.19274E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 324 z1= 1 -.585237681216556E-02 0.000000000000000E+00 z1= 2 -.119131952846961E-04 0.000000000000000E+00 z1= 3 -.504369188701300E-04 0.000000000000000E+00 alpha(00000324)=0.000000000000000E+00 beta (00000325)=0.130036577454352E+02 gamma(00000325)=0.130036577454352E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.20837E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 325 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000325)=0.000000000000000E+00 beta (00000326)=0.134466170554595E+02 gamma(00000326)=0.134466170554595E+02 lr_calc_dens: Charge drift due to real space implementation = 0.19329E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 326 z1= 1 0.590358280560469E-02 0.000000000000000E+00 z1= 2 0.131789458791981E-04 0.000000000000000E+00 z1= 3 0.503141227323312E-04 0.000000000000000E+00 alpha(00000326)=0.000000000000000E+00 beta (00000327)=0.130884021548626E+02 gamma(00000327)=0.130884021548626E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.15457E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 327 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000327)=0.000000000000000E+00 beta (00000328)=0.135357533187612E+02 gamma(00000328)=0.135357533187612E+02 lr_calc_dens: Charge drift due to real space implementation = 0.83907E-10 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 328 z1= 1 -.576191476273923E-02 0.000000000000000E+00 z1= 2 -.147555032987950E-04 0.000000000000000E+00 z1= 3 -.498970471897688E-04 0.000000000000000E+00 alpha(00000328)=0.000000000000000E+00 beta (00000329)=0.130464036522276E+02 gamma(00000329)=0.130464036522276E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10250E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 329 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000329)=0.000000000000000E+00 beta (00000330)=0.134263521962169E+02 gamma(00000330)=0.134263521962169E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10836E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 330 z1= 1 0.554656006379405E-02 0.000000000000000E+00 z1= 2 0.183859250156189E-04 0.000000000000000E+00 z1= 3 0.496406740596414E-04 0.000000000000000E+00 alpha(00000330)=0.000000000000000E+00 beta (00000331)=0.129972312302235E+02 gamma(00000331)=0.129972312302235E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.55626E-10 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 331 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000331)=0.000000000000000E+00 beta (00000332)=0.134602117577228E+02 gamma(00000332)=0.134602117577228E+02 lr_calc_dens: Charge drift due to real space implementation = 0.13468E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 332 z1= 1 -.527624524455021E-02 0.000000000000000E+00 z1= 2 -.225123095871863E-04 0.000000000000000E+00 z1= 3 -.487631006161521E-04 0.000000000000000E+00 alpha(00000332)=0.000000000000000E+00 beta (00000333)=0.130341444192145E+02 gamma(00000333)=0.130341444192145E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14976E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 333 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000333)=0.000000000000000E+00 beta (00000334)=0.135205713513010E+02 gamma(00000334)=0.135205713513010E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10406E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 334 z1= 1 0.505998790025734E-02 0.000000000000000E+00 z1= 2 0.243541924055406E-04 0.000000000000000E+00 z1= 3 0.476685063060646E-04 0.000000000000000E+00 alpha(00000334)=0.000000000000000E+00 beta (00000335)=0.130703485095106E+02 gamma(00000335)=0.130703485095106E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.13762E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 335 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000335)=0.000000000000000E+00 beta (00000336)=0.135439711302886E+02 gamma(00000336)=0.135439711302886E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11008E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 336 z1= 1 -.491245471795063E-02 0.000000000000000E+00 z1= 2 -.258186002804941E-04 0.000000000000000E+00 z1= 3 -.467863997430676E-04 0.000000000000000E+00 alpha(00000336)=0.000000000000000E+00 beta (00000337)=0.130139915221100E+02 gamma(00000337)=0.130139915221100E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.21261E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 337 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000337)=0.000000000000000E+00 beta (00000338)=0.134731502091342E+02 gamma(00000338)=0.134731502091342E+02 lr_calc_dens: Charge drift due to real space implementation = 0.84033E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 338 z1= 1 0.484217198903935E-02 0.000000000000000E+00 z1= 2 0.268707996065225E-04 0.000000000000000E+00 z1= 3 0.464650990652573E-04 0.000000000000000E+00 alpha(00000338)=0.000000000000000E+00 beta (00000339)=0.130363583868416E+02 gamma(00000339)=0.130363583868416E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.51205E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 339 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000339)=0.000000000000000E+00 beta (00000340)=0.135089414456566E+02 gamma(00000340)=0.135089414456566E+02 lr_calc_dens: Charge drift due to real space implementation = -0.25639E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 340 z1= 1 -.482363793926397E-02 0.000000000000000E+00 z1= 2 -.250541048970165E-04 0.000000000000000E+00 z1= 3 -.466293501276293E-04 0.000000000000000E+00 alpha(00000340)=0.000000000000000E+00 beta (00000341)=0.130287088098535E+02 gamma(00000341)=0.130287088098535E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.96302E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 341 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000341)=0.000000000000000E+00 beta (00000342)=0.134324221515700E+02 gamma(00000342)=0.134324221515700E+02 lr_calc_dens: Charge drift due to real space implementation = -0.86630E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 342 z1= 1 0.485404933925760E-02 0.000000000000000E+00 z1= 2 0.232090231449059E-04 0.000000000000000E+00 z1= 3 0.470754450600752E-04 0.000000000000000E+00 alpha(00000342)=0.000000000000000E+00 beta (00000343)=0.130078912468610E+02 gamma(00000343)=0.130078912468610E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.23207E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 343 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000343)=0.000000000000000E+00 beta (00000344)=0.134927881296751E+02 gamma(00000344)=0.134927881296751E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11419E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 344 z1= 1 -.472643100386120E-02 0.000000000000000E+00 z1= 2 -.254181308990235E-04 0.000000000000000E+00 z1= 3 -.470849836082299E-04 0.000000000000000E+00 alpha(00000344)=0.000000000000000E+00 beta (00000345)=0.129449629732068E+02 gamma(00000345)=0.129449629732068E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.63044E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 345 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000345)=0.000000000000000E+00 beta (00000346)=0.134776075358555E+02 gamma(00000346)=0.134776075358555E+02 lr_calc_dens: Charge drift due to real space implementation = -0.70457E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 346 z1= 1 0.448920508977508E-02 0.000000000000000E+00 z1= 2 0.268940321800030E-04 0.000000000000000E+00 z1= 3 0.468640166748536E-04 0.000000000000000E+00 alpha(00000346)=0.000000000000000E+00 beta (00000347)=0.130776152320874E+02 gamma(00000347)=0.130776152320874E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.82134E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 347 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000347)=0.000000000000000E+00 beta (00000348)=0.134781805063509E+02 gamma(00000348)=0.134781805063509E+02 lr_calc_dens: Charge drift due to real space implementation = 0.65526E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 348 z1= 1 -.425521274698741E-02 0.000000000000000E+00 z1= 2 -.276419931379678E-04 0.000000000000000E+00 z1= 3 -.470086234564928E-04 0.000000000000000E+00 alpha(00000348)=0.000000000000000E+00 beta (00000349)=0.130502184109136E+02 gamma(00000349)=0.130502184109136E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12457E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 349 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000349)=0.000000000000000E+00 beta (00000350)=0.134669963734142E+02 gamma(00000350)=0.134669963734142E+02 lr_calc_dens: Charge drift due to real space implementation = -0.74942E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 350 z1= 1 0.403895145757305E-02 0.000000000000000E+00 z1= 2 0.291972393225634E-04 0.000000000000000E+00 z1= 3 0.468655626948881E-04 0.000000000000000E+00 alpha(00000350)=0.000000000000000E+00 beta (00000351)=0.130092210659512E+02 gamma(00000351)=0.130092210659512E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.24215E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 351 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000351)=0.000000000000000E+00 beta (00000352)=0.134834215697368E+02 gamma(00000352)=0.134834215697368E+02 lr_calc_dens: Charge drift due to real space implementation = -0.26391E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 352 z1= 1 -.391872237783595E-02 0.000000000000000E+00 z1= 2 -.300484245813384E-04 0.000000000000000E+00 z1= 3 -.466092750297905E-04 0.000000000000000E+00 alpha(00000352)=0.000000000000000E+00 beta (00000353)=0.130284929732051E+02 gamma(00000353)=0.130284929732051E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.27429E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 353 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000353)=0.000000000000000E+00 beta (00000354)=0.135024942484663E+02 gamma(00000354)=0.135024942484663E+02 lr_calc_dens: Charge drift due to real space implementation = 0.18367E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 354 z1= 1 0.385699767392314E-02 0.000000000000000E+00 z1= 2 0.294787164073392E-04 0.000000000000000E+00 z1= 3 0.466812967464470E-04 0.000000000000000E+00 alpha(00000354)=0.000000000000000E+00 beta (00000355)=0.130310891920823E+02 gamma(00000355)=0.130310891920823E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11594E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 355 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000355)=0.000000000000000E+00 beta (00000356)=0.135230256457658E+02 gamma(00000356)=0.135230256457658E+02 lr_calc_dens: Charge drift due to real space implementation = -0.17066E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 356 z1= 1 -.382068796048077E-02 0.000000000000000E+00 z1= 2 -.277417180383306E-04 0.000000000000000E+00 z1= 3 -.469122992817363E-04 0.000000000000000E+00 alpha(00000356)=0.000000000000000E+00 beta (00000357)=0.130595641361107E+02 gamma(00000357)=0.130595641361107E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.24196E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 357 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000357)=0.000000000000000E+00 beta (00000358)=0.134547279227516E+02 gamma(00000358)=0.134547279227516E+02 lr_calc_dens: Charge drift due to real space implementation = 0.26454E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 358 z1= 1 0.390232259533224E-02 0.000000000000000E+00 z1= 2 0.298489759672149E-04 0.000000000000000E+00 z1= 3 0.478099032880156E-04 0.000000000000000E+00 alpha(00000358)=0.000000000000000E+00 beta (00000359)=0.130992230454925E+02 gamma(00000359)=0.130992230454925E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.15866E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 359 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000359)=0.000000000000000E+00 beta (00000360)=0.134094754887828E+02 gamma(00000360)=0.134094754887828E+02 lr_calc_dens: Charge drift due to real space implementation = 0.61427E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 360 z1= 1 -.407040153013928E-02 0.000000000000000E+00 z1= 2 -.323855898476597E-04 0.000000000000000E+00 z1= 3 -.492623253048656E-04 0.000000000000000E+00 alpha(00000360)=0.000000000000000E+00 beta (00000361)=0.130052326075771E+02 gamma(00000361)=0.130052326075771E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.55716E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 361 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000361)=0.000000000000000E+00 beta (00000362)=0.134221692838601E+02 gamma(00000362)=0.134221692838601E+02 lr_calc_dens: Charge drift due to real space implementation = -0.49346E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 362 z1= 1 0.436068881349332E-02 0.000000000000000E+00 z1= 2 0.342067494865121E-04 0.000000000000000E+00 z1= 3 0.500413015005112E-04 0.000000000000000E+00 alpha(00000362)=0.000000000000000E+00 beta (00000363)=0.129925628261649E+02 gamma(00000363)=0.129925628261649E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.13695E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 363 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000363)=0.000000000000000E+00 beta (00000364)=0.135560152153250E+02 gamma(00000364)=0.135560152153250E+02 lr_calc_dens: Charge drift due to real space implementation = -0.93471E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 364 z1= 1 -.479404762209270E-02 0.000000000000000E+00 z1= 2 -.344465355439161E-04 0.000000000000000E+00 z1= 3 -.499940758602734E-04 0.000000000000000E+00 alpha(00000364)=0.000000000000000E+00 beta (00000365)=0.129954858014918E+02 gamma(00000365)=0.129954858014918E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.53502E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 365 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000365)=0.000000000000000E+00 beta (00000366)=0.134388033798314E+02 gamma(00000366)=0.134388033798314E+02 lr_calc_dens: Charge drift due to real space implementation = 0.13174E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 366 z1= 1 0.539097116366296E-02 0.000000000000000E+00 z1= 2 0.343795689834614E-04 0.000000000000000E+00 z1= 3 0.504703772868289E-04 0.000000000000000E+00 alpha(00000366)=0.000000000000000E+00 beta (00000367)=0.130003258740134E+02 gamma(00000367)=0.130003258740134E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.72831E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 367 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000367)=0.000000000000000E+00 beta (00000368)=0.134957352177833E+02 gamma(00000368)=0.134957352177833E+02 lr_calc_dens: Charge drift due to real space implementation = 0.20836E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 368 z1= 1 -.603440946753147E-02 0.000000000000000E+00 z1= 2 -.337796544614627E-04 0.000000000000000E+00 z1= 3 -.507769490521730E-04 0.000000000000000E+00 alpha(00000368)=0.000000000000000E+00 beta (00000369)=0.130569336545452E+02 gamma(00000369)=0.130569336545452E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13010E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 369 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000369)=0.000000000000000E+00 beta (00000370)=0.134893896590444E+02 gamma(00000370)=0.134893896590444E+02 lr_calc_dens: Charge drift due to real space implementation = -0.75754E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 370 z1= 1 0.670930003909522E-02 0.000000000000000E+00 z1= 2 0.332924997496734E-04 0.000000000000000E+00 z1= 3 0.512976857501219E-04 0.000000000000000E+00 alpha(00000370)=0.000000000000000E+00 beta (00000371)=0.129926716848470E+02 gamma(00000371)=0.129926716848470E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12633E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 371 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000371)=0.000000000000000E+00 beta (00000372)=0.134544135566742E+02 gamma(00000372)=0.134544135566742E+02 lr_calc_dens: Charge drift due to real space implementation = 0.40390E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 372 z1= 1 -.724810888960803E-02 0.000000000000000E+00 z1= 2 -.337432833829336E-04 0.000000000000000E+00 z1= 3 -.519099662934507E-04 0.000000000000000E+00 alpha(00000372)=0.000000000000000E+00 beta (00000373)=0.129945070468450E+02 gamma(00000373)=0.129945070468450E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.19875E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 373 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000373)=0.000000000000000E+00 beta (00000374)=0.134167017761864E+02 gamma(00000374)=0.134167017761864E+02 lr_calc_dens: Charge drift due to real space implementation = 0.49457E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 374 z1= 1 0.765224887969429E-02 0.000000000000000E+00 z1= 2 0.333881585002083E-04 0.000000000000000E+00 z1= 3 0.530918924233035E-04 0.000000000000000E+00 alpha(00000374)=0.000000000000000E+00 beta (00000375)=0.130486963344681E+02 gamma(00000375)=0.130486963344681E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.20370E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 375 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000375)=0.000000000000000E+00 beta (00000376)=0.135820785910565E+02 gamma(00000376)=0.135820785910565E+02 lr_calc_dens: Charge drift due to real space implementation = -0.16582E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 376 z1= 1 -.793164481982075E-02 0.000000000000000E+00 z1= 2 -.318161368290924E-04 0.000000000000000E+00 z1= 3 -.536245028390830E-04 0.000000000000000E+00 alpha(00000376)=0.000000000000000E+00 beta (00000377)=0.130025799937238E+02 gamma(00000377)=0.130025799937238E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.60445E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 377 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000377)=0.000000000000000E+00 beta (00000378)=0.134790283032350E+02 gamma(00000378)=0.134790283032350E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12489E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 378 z1= 1 0.823930453884351E-02 0.000000000000000E+00 z1= 2 0.321728949806478E-04 0.000000000000000E+00 z1= 3 0.539884119822204E-04 0.000000000000000E+00 alpha(00000378)=0.000000000000000E+00 beta (00000379)=0.130598390605726E+02 gamma(00000379)=0.130598390605726E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.44262E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 379 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000379)=0.000000000000000E+00 beta (00000380)=0.135060641220378E+02 gamma(00000380)=0.135060641220378E+02 lr_calc_dens: Charge drift due to real space implementation = 0.22378E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 380 z1= 1 -.861562646596034E-02 0.000000000000000E+00 z1= 2 -.343008972931002E-04 0.000000000000000E+00 z1= 3 -.544215213698167E-04 0.000000000000000E+00 alpha(00000380)=0.000000000000000E+00 beta (00000381)=0.129343755540666E+02 gamma(00000381)=0.129343755540666E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.68287E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 381 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000381)=0.000000000000000E+00 beta (00000382)=0.135712550254226E+02 gamma(00000382)=0.135712550254226E+02 lr_calc_dens: Charge drift due to real space implementation = 0.50898E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 382 z1= 1 0.896571115378674E-02 0.000000000000000E+00 z1= 2 0.358030975712411E-04 0.000000000000000E+00 z1= 3 0.543271403752692E-04 0.000000000000000E+00 alpha(00000382)=0.000000000000000E+00 beta (00000383)=0.130920061812846E+02 gamma(00000383)=0.130920061812846E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.68497E-10 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 383 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000383)=0.000000000000000E+00 beta (00000384)=0.134682911640096E+02 gamma(00000384)=0.134682911640096E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10418E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 384 z1= 1 -.952559269948946E-02 0.000000000000000E+00 z1= 2 -.361721765261567E-04 0.000000000000000E+00 z1= 3 -.552201016100486E-04 0.000000000000000E+00 alpha(00000384)=0.000000000000000E+00 beta (00000385)=0.130437279884398E+02 gamma(00000385)=0.130437279884398E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.40990E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 385 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000385)=0.000000000000000E+00 beta (00000386)=0.136029197748890E+02 gamma(00000386)=0.136029197748890E+02 lr_calc_dens: Charge drift due to real space implementation = -0.39253E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 386 z1= 1 0.996986575907012E-02 0.000000000000000E+00 z1= 2 0.354615237970358E-04 0.000000000000000E+00 z1= 3 0.552063588028648E-04 0.000000000000000E+00 alpha(00000386)=0.000000000000000E+00 beta (00000387)=0.130608351458283E+02 gamma(00000387)=0.130608351458283E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.15330E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 387 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000387)=0.000000000000000E+00 beta (00000388)=0.134876765364095E+02 gamma(00000388)=0.134876765364095E+02 lr_calc_dens: Charge drift due to real space implementation = -0.87157E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 388 z1= 1 -.104527870095088E-01 0.000000000000000E+00 z1= 2 -.362191694531925E-04 0.000000000000000E+00 z1= 3 -.561487123469202E-04 0.000000000000000E+00 alpha(00000388)=0.000000000000000E+00 beta (00000389)=0.130361755165620E+02 gamma(00000389)=0.130361755165620E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.62854E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 389 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000389)=0.000000000000000E+00 beta (00000390)=0.135229901225485E+02 gamma(00000390)=0.135229901225485E+02 lr_calc_dens: Charge drift due to real space implementation = 0.33086E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 390 z1= 1 0.107556841398124E-01 0.000000000000000E+00 z1= 2 0.365075145773285E-04 0.000000000000000E+00 z1= 3 0.574122925574443E-04 0.000000000000000E+00 alpha(00000390)=0.000000000000000E+00 beta (00000391)=0.130435694518909E+02 gamma(00000391)=0.130435694518909E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.72683E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 391 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000391)=0.000000000000000E+00 beta (00000392)=0.135234534174815E+02 gamma(00000392)=0.135234534174815E+02 lr_calc_dens: Charge drift due to real space implementation = -0.16770E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 392 z1= 1 -.110050788891768E-01 0.000000000000000E+00 z1= 2 -.360021482537429E-04 0.000000000000000E+00 z1= 3 -.585559321544657E-04 0.000000000000000E+00 alpha(00000392)=0.000000000000000E+00 beta (00000393)=0.130112582258157E+02 gamma(00000393)=0.130112582258157E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.11698E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 393 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000393)=0.000000000000000E+00 beta (00000394)=0.134846392126644E+02 gamma(00000394)=0.134846392126644E+02 lr_calc_dens: Charge drift due to real space implementation = 0.76464E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 394 z1= 1 0.111966803161029E-01 0.000000000000000E+00 z1= 2 0.372336982918334E-04 0.000000000000000E+00 z1= 3 0.596421261171241E-04 0.000000000000000E+00 alpha(00000394)=0.000000000000000E+00 beta (00000395)=0.130579477553083E+02 gamma(00000395)=0.130579477553083E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.89845E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 395 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000395)=0.000000000000000E+00 beta (00000396)=0.134674912387167E+02 gamma(00000396)=0.134674912387167E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11232E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 396 z1= 1 -.113885493548763E-01 0.000000000000000E+00 z1= 2 -.385585349794177E-04 0.000000000000000E+00 z1= 3 -.609305982353202E-04 0.000000000000000E+00 alpha(00000396)=0.000000000000000E+00 beta (00000397)=0.130363480909743E+02 gamma(00000397)=0.130363480909743E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.20314E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 397 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000397)=0.000000000000000E+00 beta (00000398)=0.133975699067146E+02 gamma(00000398)=0.133975699067146E+02 lr_calc_dens: Charge drift due to real space implementation = 0.72356E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 398 z1= 1 0.115158022445186E-01 0.000000000000000E+00 z1= 2 0.398756307430775E-04 0.000000000000000E+00 z1= 3 0.622960515385230E-04 0.000000000000000E+00 alpha(00000398)=0.000000000000000E+00 beta (00000399)=0.130175636309218E+02 gamma(00000399)=0.130175636309218E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.77363E-11 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 399 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000399)=0.000000000000000E+00 beta (00000400)=0.134931885651360E+02 gamma(00000400)=0.134931885651360E+02 lr_calc_dens: Charge drift due to real space implementation = -0.53399E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 400 z1= 1 -.115644846624072E-01 0.000000000000000E+00 z1= 2 -.390719265430835E-04 0.000000000000000E+00 z1= 3 -.629749970717441E-04 0.000000000000000E+00 alpha(00000400)=0.000000000000000E+00 beta (00000401)=0.130168994542003E+02 gamma(00000401)=0.130168994542003E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.48177E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 401 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000401)=0.000000000000000E+00 beta (00000402)=0.134367392455591E+02 gamma(00000402)=0.134367392455591E+02 lr_calc_dens: Charge drift due to real space implementation = -0.33263E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 402 z1= 1 0.118276356418059E-01 0.000000000000000E+00 z1= 2 0.393748532581256E-04 0.000000000000000E+00 z1= 3 0.636824308453027E-04 0.000000000000000E+00 alpha(00000402)=0.000000000000000E+00 beta (00000403)=0.130173798713103E+02 gamma(00000403)=0.130173798713103E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.13996E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 403 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000403)=0.000000000000000E+00 beta (00000404)=0.135217511338311E+02 gamma(00000404)=0.135217511338311E+02 lr_calc_dens: Charge drift due to real space implementation = 0.18425E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 404 z1= 1 -.121789439739250E-01 0.000000000000000E+00 z1= 2 -.393613843457461E-04 0.000000000000000E+00 z1= 3 -.636076652595981E-04 0.000000000000000E+00 alpha(00000404)=0.000000000000000E+00 beta (00000405)=0.130009520805160E+02 gamma(00000405)=0.130009520805160E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10538E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 405 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000405)=0.000000000000000E+00 beta (00000406)=0.135067601529124E+02 gamma(00000406)=0.135067601529124E+02 lr_calc_dens: Charge drift due to real space implementation = -0.70841E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 406 z1= 1 0.126008596067276E-01 0.000000000000000E+00 z1= 2 0.392337856163771E-04 0.000000000000000E+00 z1= 3 0.628389818953347E-04 0.000000000000000E+00 alpha(00000406)=0.000000000000000E+00 beta (00000407)=0.129832053603723E+02 gamma(00000407)=0.129832053603723E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.38442E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 407 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000407)=0.000000000000000E+00 beta (00000408)=0.135219740827142E+02 gamma(00000408)=0.135219740827142E+02 lr_calc_dens: Charge drift due to real space implementation = 0.82872E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 408 z1= 1 -.129646945485758E-01 0.000000000000000E+00 z1= 2 -.398359179112377E-04 0.000000000000000E+00 z1= 3 -.611949550438926E-04 0.000000000000000E+00 alpha(00000408)=0.000000000000000E+00 beta (00000409)=0.130280556540764E+02 gamma(00000409)=0.130280556540764E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12469E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 409 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000409)=0.000000000000000E+00 beta (00000410)=0.135142244304627E+02 gamma(00000410)=0.135142244304627E+02 lr_calc_dens: Charge drift due to real space implementation = -0.13047E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 410 z1= 1 0.133661377463493E-01 0.000000000000000E+00 z1= 2 0.414748255152912E-04 0.000000000000000E+00 z1= 3 0.592854984864212E-04 0.000000000000000E+00 alpha(00000410)=0.000000000000000E+00 beta (00000411)=0.130415236825882E+02 gamma(00000411)=0.130415236825882E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.14378E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 411 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000411)=0.000000000000000E+00 beta (00000412)=0.134708304257358E+02 gamma(00000412)=0.134708304257358E+02 lr_calc_dens: Charge drift due to real space implementation = -0.43561E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 412 z1= 1 -.138144389423071E-01 0.000000000000000E+00 z1= 2 -.443876985748940E-04 0.000000000000000E+00 z1= 3 -.572527203818773E-04 0.000000000000000E+00 alpha(00000412)=0.000000000000000E+00 beta (00000413)=0.130411505093198E+02 gamma(00000413)=0.130411505093198E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.15849E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 413 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000413)=0.000000000000000E+00 beta (00000414)=0.135319418289157E+02 gamma(00000414)=0.135319418289157E+02 lr_calc_dens: Charge drift due to real space implementation = 0.14353E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 414 z1= 1 0.141468790393484E-01 0.000000000000000E+00 z1= 2 0.454861977697042E-04 0.000000000000000E+00 z1= 3 0.552539623075540E-04 0.000000000000000E+00 alpha(00000414)=0.000000000000000E+00 beta (00000415)=0.130576787305774E+02 gamma(00000415)=0.130576787305774E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.67323E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 415 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000415)=0.000000000000000E+00 beta (00000416)=0.134548353664281E+02 gamma(00000416)=0.134548353664281E+02 lr_calc_dens: Charge drift due to real space implementation = -0.16115E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 416 z1= 1 -.145234874750205E-01 0.000000000000000E+00 z1= 2 -.448565175801821E-04 0.000000000000000E+00 z1= 3 -.540410662371892E-04 0.000000000000000E+00 alpha(00000416)=0.000000000000000E+00 beta (00000417)=0.130789003079831E+02 gamma(00000417)=0.130789003079831E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.35527E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 417 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000417)=0.000000000000000E+00 beta (00000418)=0.135278875563680E+02 gamma(00000418)=0.135278875563680E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11951E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 418 z1= 1 0.146840779324290E-01 0.000000000000000E+00 z1= 2 0.442637109877798E-04 0.000000000000000E+00 z1= 3 0.528791458415133E-04 0.000000000000000E+00 alpha(00000418)=0.000000000000000E+00 beta (00000419)=0.130832593921860E+02 gamma(00000419)=0.130832593921860E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14931E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 419 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000419)=0.000000000000000E+00 beta (00000420)=0.136009154758465E+02 gamma(00000420)=0.136009154758465E+02 lr_calc_dens: Charge drift due to real space implementation = 0.35556E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 420 z1= 1 -.146922720212418E-01 0.000000000000000E+00 z1= 2 -.448406693680918E-04 0.000000000000000E+00 z1= 3 -.522577245975353E-04 0.000000000000000E+00 alpha(00000420)=0.000000000000000E+00 beta (00000421)=0.130097405857864E+02 gamma(00000421)=0.130097405857864E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.13279E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 421 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000421)=0.000000000000000E+00 beta (00000422)=0.134126399318474E+02 gamma(00000422)=0.134126399318474E+02 lr_calc_dens: Charge drift due to real space implementation = -0.18211E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 422 z1= 1 0.149010965576629E-01 0.000000000000000E+00 z1= 2 0.461908858792374E-04 0.000000000000000E+00 z1= 3 0.530407890131873E-04 0.000000000000000E+00 alpha(00000422)=0.000000000000000E+00 beta (00000423)=0.129465758226923E+02 gamma(00000423)=0.129465758226923E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.63187E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 423 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000423)=0.000000000000000E+00 beta (00000424)=0.135257045476857E+02 gamma(00000424)=0.135257045476857E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10354E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 424 z1= 1 -.150129696529367E-01 0.000000000000000E+00 z1= 2 -.466095326466260E-04 0.000000000000000E+00 z1= 3 -.533894125709724E-04 0.000000000000000E+00 alpha(00000424)=0.000000000000000E+00 beta (00000425)=0.129622053403456E+02 gamma(00000425)=0.129622053403456E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12809E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 425 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000425)=0.000000000000000E+00 beta (00000426)=0.135823671412776E+02 gamma(00000426)=0.135823671412776E+02 lr_calc_dens: Charge drift due to real space implementation = -0.58696E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 426 z1= 1 0.151428348989517E-01 0.000000000000000E+00 z1= 2 0.472327211572740E-04 0.000000000000000E+00 z1= 3 0.533555220785868E-04 0.000000000000000E+00 alpha(00000426)=0.000000000000000E+00 beta (00000427)=0.130500200923809E+02 gamma(00000427)=0.130500200923809E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.18931E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 427 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000427)=0.000000000000000E+00 beta (00000428)=0.134417941065832E+02 gamma(00000428)=0.134417941065832E+02 lr_calc_dens: Charge drift due to real space implementation = -0.30518E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 428 z1= 1 -.154418070634786E-01 0.000000000000000E+00 z1= 2 -.477421659957866E-04 0.000000000000000E+00 z1= 3 -.541560098100834E-04 0.000000000000000E+00 alpha(00000428)=0.000000000000000E+00 beta (00000429)=0.130006955824215E+02 gamma(00000429)=0.130006955824215E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.18274E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 429 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000429)=0.000000000000000E+00 beta (00000430)=0.134759954571552E+02 gamma(00000430)=0.134759954571552E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11946E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 430 z1= 1 0.155112432153144E-01 0.000000000000000E+00 z1= 2 0.489098137532516E-04 0.000000000000000E+00 z1= 3 0.553894000287905E-04 0.000000000000000E+00 alpha(00000430)=0.000000000000000E+00 beta (00000431)=0.130681133934731E+02 gamma(00000431)=0.130681133934731E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.78245E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 431 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000431)=0.000000000000000E+00 beta (00000432)=0.134398203657537E+02 gamma(00000432)=0.134398203657537E+02 lr_calc_dens: Charge drift due to real space implementation = -0.80875E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 432 z1= 1 -.155810017226807E-01 0.000000000000000E+00 z1= 2 -.502974937387759E-04 0.000000000000000E+00 z1= 3 -.572653451290257E-04 0.000000000000000E+00 alpha(00000432)=0.000000000000000E+00 beta (00000433)=0.130404999271188E+02 gamma(00000433)=0.130404999271188E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.31557E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 433 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000433)=0.000000000000000E+00 beta (00000434)=0.135062099561525E+02 gamma(00000434)=0.135062099561525E+02 lr_calc_dens: Charge drift due to real space implementation = 0.14367E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 434 z1= 1 0.154141203471445E-01 0.000000000000000E+00 z1= 2 0.516004370926209E-04 0.000000000000000E+00 z1= 3 0.583748978789362E-04 0.000000000000000E+00 alpha(00000434)=0.000000000000000E+00 beta (00000435)=0.129842159387934E+02 gamma(00000435)=0.129842159387934E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.42629E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 435 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000435)=0.000000000000000E+00 beta (00000436)=0.134324107847112E+02 gamma(00000436)=0.134324107847112E+02 lr_calc_dens: Charge drift due to real space implementation = 0.26465E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 436 z1= 1 -.151613884283729E-01 0.000000000000000E+00 z1= 2 -.542240084006698E-04 0.000000000000000E+00 z1= 3 -.593253167925956E-04 0.000000000000000E+00 alpha(00000436)=0.000000000000000E+00 beta (00000437)=0.129689525993824E+02 gamma(00000437)=0.129689525993824E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.85947E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 437 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000437)=0.000000000000000E+00 beta (00000438)=0.134704800778179E+02 gamma(00000438)=0.134704800778179E+02 lr_calc_dens: Charge drift due to real space implementation = -0.39586E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 438 z1= 1 0.147447965690907E-01 0.000000000000000E+00 z1= 2 0.566142440441781E-04 0.000000000000000E+00 z1= 3 0.590638822922000E-04 0.000000000000000E+00 alpha(00000438)=0.000000000000000E+00 beta (00000439)=0.130901623846751E+02 gamma(00000439)=0.130901623846751E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.16897E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 439 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000439)=0.000000000000000E+00 beta (00000440)=0.135203653814650E+02 gamma(00000440)=0.135203653814650E+02 lr_calc_dens: Charge drift due to real space implementation = -0.34168E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 440 z1= 1 -.144248833667231E-01 0.000000000000000E+00 z1= 2 -.564220590018279E-04 0.000000000000000E+00 z1= 3 -.579332925144345E-04 0.000000000000000E+00 alpha(00000440)=0.000000000000000E+00 beta (00000441)=0.130166976177817E+02 gamma(00000441)=0.130166976177817E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.18049E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 441 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000441)=0.000000000000000E+00 beta (00000442)=0.134172113700546E+02 gamma(00000442)=0.134172113700546E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11884E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 442 z1= 1 0.141560285254441E-01 0.000000000000000E+00 z1= 2 0.568802447413182E-04 0.000000000000000E+00 z1= 3 0.561890039966793E-04 0.000000000000000E+00 alpha(00000442)=0.000000000000000E+00 beta (00000443)=0.130548942524261E+02 gamma(00000443)=0.130548942524261E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10373E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 443 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000443)=0.000000000000000E+00 beta (00000444)=0.135535860592318E+02 gamma(00000444)=0.135535860592318E+02 lr_calc_dens: Charge drift due to real space implementation = -0.94333E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 444 z1= 1 -.138233896305609E-01 0.000000000000000E+00 z1= 2 -.587372094412895E-04 0.000000000000000E+00 z1= 3 -.540059672184697E-04 0.000000000000000E+00 alpha(00000444)=0.000000000000000E+00 beta (00000445)=0.130970885155949E+02 gamma(00000445)=0.130970885155949E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.99531E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 445 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000445)=0.000000000000000E+00 beta (00000446)=0.136024142958376E+02 gamma(00000446)=0.136024142958376E+02 lr_calc_dens: Charge drift due to real space implementation = 0.96229E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 446 z1= 1 0.135071269386078E-01 0.000000000000000E+00 z1= 2 0.602437068899682E-04 0.000000000000000E+00 z1= 3 0.523202368748171E-04 0.000000000000000E+00 alpha(00000446)=0.000000000000000E+00 beta (00000447)=0.129884535153512E+02 gamma(00000447)=0.129884535153512E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.58064E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 447 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000447)=0.000000000000000E+00 beta (00000448)=0.134956011989676E+02 gamma(00000448)=0.134956011989676E+02 lr_calc_dens: Charge drift due to real space implementation = -0.43395E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 448 z1= 1 -.130997590816588E-01 0.000000000000000E+00 z1= 2 -.606647828645702E-04 0.000000000000000E+00 z1= 3 -.512241606040186E-04 0.000000000000000E+00 alpha(00000448)=0.000000000000000E+00 beta (00000449)=0.129883052409246E+02 gamma(00000449)=0.129883052409246E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.72889E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 449 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000449)=0.000000000000000E+00 beta (00000450)=0.135763698189584E+02 gamma(00000450)=0.135763698189584E+02 lr_calc_dens: Charge drift due to real space implementation = 0.21339E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 450 z1= 1 0.125811236839942E-01 0.000000000000000E+00 z1= 2 0.603772839367148E-04 0.000000000000000E+00 z1= 3 0.505174767143259E-04 0.000000000000000E+00 alpha(00000450)=0.000000000000000E+00 beta (00000451)=0.130060996232161E+02 gamma(00000451)=0.130060996232161E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.14108E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 451 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000451)=0.000000000000000E+00 beta (00000452)=0.135219815177557E+02 gamma(00000452)=0.135219815177557E+02 lr_calc_dens: Charge drift due to real space implementation = -0.14837E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 452 z1= 1 -.120532839346563E-01 0.000000000000000E+00 z1= 2 -.605692465359634E-04 0.000000000000000E+00 z1= 3 -.507355538233495E-04 0.000000000000000E+00 alpha(00000452)=0.000000000000000E+00 beta (00000453)=0.129962395941494E+02 gamma(00000453)=0.129962395941494E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.13461E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 453 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000453)=0.000000000000000E+00 beta (00000454)=0.135248458142097E+02 gamma(00000454)=0.135248458142097E+02 lr_calc_dens: Charge drift due to real space implementation = 0.28567E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 454 z1= 1 0.113347893251191E-01 0.000000000000000E+00 z1= 2 0.615785957455419E-04 0.000000000000000E+00 z1= 3 0.518064357341627E-04 0.000000000000000E+00 alpha(00000454)=0.000000000000000E+00 beta (00000455)=0.130621329608623E+02 gamma(00000455)=0.130621329608623E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.80077E-10 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 455 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000455)=0.000000000000000E+00 beta (00000456)=0.134704102186018E+02 gamma(00000456)=0.134704102186018E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11391E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 456 z1= 1 -.105543936357456E-01 0.000000000000000E+00 z1= 2 -.622241748368894E-04 0.000000000000000E+00 z1= 3 -.539789702431356E-04 0.000000000000000E+00 alpha(00000456)=0.000000000000000E+00 beta (00000457)=0.129933728319357E+02 gamma(00000457)=0.129933728319357E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.20220E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 457 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000457)=0.000000000000000E+00 beta (00000458)=0.134613024443545E+02 gamma(00000458)=0.134613024443545E+02 lr_calc_dens: Charge drift due to real space implementation = 0.32208E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 458 z1= 1 0.969215915474728E-02 0.000000000000000E+00 z1= 2 0.616540221369585E-04 0.000000000000000E+00 z1= 3 0.559100354191872E-04 0.000000000000000E+00 alpha(00000458)=0.000000000000000E+00 beta (00000459)=0.130204797546718E+02 gamma(00000459)=0.130204797546718E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.22199E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 459 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000459)=0.000000000000000E+00 beta (00000460)=0.134661085930478E+02 gamma(00000460)=0.134661085930478E+02 lr_calc_dens: Charge drift due to real space implementation = -0.19001E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 460 z1= 1 -.888529924524849E-02 0.000000000000000E+00 z1= 2 -.626591290416693E-04 0.000000000000000E+00 z1= 3 -.574160870841220E-04 0.000000000000000E+00 alpha(00000460)=0.000000000000000E+00 beta (00000461)=0.130562208808132E+02 gamma(00000461)=0.130562208808132E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.79449E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 461 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000461)=0.000000000000000E+00 beta (00000462)=0.136039907186231E+02 gamma(00000462)=0.136039907186231E+02 lr_calc_dens: Charge drift due to real space implementation = 0.22872E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 462 z1= 1 0.804748002524880E-02 0.000000000000000E+00 z1= 2 0.617224565172721E-04 0.000000000000000E+00 z1= 3 0.573676250503319E-04 0.000000000000000E+00 alpha(00000462)=0.000000000000000E+00 beta (00000463)=0.130357527701433E+02 gamma(00000463)=0.130357527701433E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14253E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 463 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000463)=0.000000000000000E+00 beta (00000464)=0.135169250214883E+02 gamma(00000464)=0.135169250214883E+02 lr_calc_dens: Charge drift due to real space implementation = -0.15059E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 464 z1= 1 -.730587865769459E-02 0.000000000000000E+00 z1= 2 -.619832492499616E-04 0.000000000000000E+00 z1= 3 -.565155068483776E-04 0.000000000000000E+00 alpha(00000464)=0.000000000000000E+00 beta (00000465)=0.130226303159436E+02 gamma(00000465)=0.130226303159436E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11329E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 465 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000465)=0.000000000000000E+00 beta (00000466)=0.134960618497570E+02 gamma(00000466)=0.134960618497570E+02 lr_calc_dens: Charge drift due to real space implementation = -0.14409E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 466 z1= 1 0.672426530551013E-02 0.000000000000000E+00 z1= 2 0.615585074990573E-04 0.000000000000000E+00 z1= 3 0.555602171881965E-04 0.000000000000000E+00 alpha(00000466)=0.000000000000000E+00 beta (00000467)=0.129405376281369E+02 gamma(00000467)=0.129405376281369E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.82794E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 467 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000467)=0.000000000000000E+00 beta (00000468)=0.135572562215366E+02 gamma(00000468)=0.135572562215366E+02 lr_calc_dens: Charge drift due to real space implementation = 0.95091E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 468 z1= 1 -.636497584361988E-02 0.000000000000000E+00 z1= 2 -.613638684679686E-04 0.000000000000000E+00 z1= 3 -.541199059723517E-04 0.000000000000000E+00 alpha(00000468)=0.000000000000000E+00 beta (00000469)=0.130597081708820E+02 gamma(00000469)=0.130597081708820E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.21560E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 469 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000469)=0.000000000000000E+00 beta (00000470)=0.134431362065076E+02 gamma(00000470)=0.134431362065076E+02 lr_calc_dens: Charge drift due to real space implementation = 0.53516E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 470 z1= 1 0.635403351157215E-02 0.000000000000000E+00 z1= 2 0.632250037703582E-04 0.000000000000000E+00 z1= 3 0.538553712501866E-04 0.000000000000000E+00 alpha(00000470)=0.000000000000000E+00 beta (00000471)=0.130066057765742E+02 gamma(00000471)=0.130066057765742E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.19585E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 471 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000471)=0.000000000000000E+00 beta (00000472)=0.135336667418958E+02 gamma(00000472)=0.135336667418958E+02 lr_calc_dens: Charge drift due to real space implementation = -0.13465E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 472 z1= 1 -.620475543139952E-02 0.000000000000000E+00 z1= 2 -.632763447602994E-04 0.000000000000000E+00 z1= 3 -.534109623369334E-04 0.000000000000000E+00 alpha(00000472)=0.000000000000000E+00 beta (00000473)=0.130871845352554E+02 gamma(00000473)=0.130871845352554E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14966E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 473 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000473)=0.000000000000000E+00 beta (00000474)=0.134906222786669E+02 gamma(00000474)=0.134906222786669E+02 lr_calc_dens: Charge drift due to real space implementation = 0.23430E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 474 z1= 1 0.608622534863928E-02 0.000000000000000E+00 z1= 2 0.629734473919256E-04 0.000000000000000E+00 z1= 3 0.539695817869874E-04 0.000000000000000E+00 alpha(00000474)=0.000000000000000E+00 beta (00000475)=0.130072030637559E+02 gamma(00000475)=0.130072030637559E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.70949E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 475 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000475)=0.000000000000000E+00 beta (00000476)=0.134177084042041E+02 gamma(00000476)=0.134177084042041E+02 lr_calc_dens: Charge drift due to real space implementation = -0.58426E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 476 z1= 1 -.595145912678840E-02 0.000000000000000E+00 z1= 2 -.626028160449332E-04 0.000000000000000E+00 z1= 3 -.547661711387970E-04 0.000000000000000E+00 alpha(00000476)=0.000000000000000E+00 beta (00000477)=0.130662234218809E+02 gamma(00000477)=0.130662234218809E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.73918E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 477 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000477)=0.000000000000000E+00 beta (00000478)=0.135169030935862E+02 gamma(00000478)=0.135169030935862E+02 lr_calc_dens: Charge drift due to real space implementation = -0.87974E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 478 z1= 1 0.580611332396620E-02 0.000000000000000E+00 z1= 2 0.614759234506407E-04 0.000000000000000E+00 z1= 3 0.550542277600801E-04 0.000000000000000E+00 alpha(00000478)=0.000000000000000E+00 beta (00000479)=0.129121831092970E+02 gamma(00000479)=0.129121831092970E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.82779E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 479 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000479)=0.000000000000000E+00 beta (00000480)=0.134352955696672E+02 gamma(00000480)=0.134352955696672E+02 lr_calc_dens: Charge drift due to real space implementation = 0.28605E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 480 z1= 1 -.578461870440358E-02 0.000000000000000E+00 z1= 2 -.588076515061903E-04 0.000000000000000E+00 z1= 3 -.547282634284751E-04 0.000000000000000E+00 alpha(00000480)=0.000000000000000E+00 beta (00000481)=0.130240968493598E+02 gamma(00000481)=0.130240968493598E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14952E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 481 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000481)=0.000000000000000E+00 beta (00000482)=0.135309825821856E+02 gamma(00000482)=0.135309825821856E+02 lr_calc_dens: Charge drift due to real space implementation = 0.90307E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 482 z1= 1 0.586604080763980E-02 0.000000000000000E+00 z1= 2 0.566013409879513E-04 0.000000000000000E+00 z1= 3 0.547210100592407E-04 0.000000000000000E+00 alpha(00000482)=0.000000000000000E+00 beta (00000483)=0.130217242794010E+02 gamma(00000483)=0.130217242794010E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11525E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 483 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000483)=0.000000000000000E+00 beta (00000484)=0.134056627552642E+02 gamma(00000484)=0.134056627552642E+02 lr_calc_dens: Charge drift due to real space implementation = -0.21878E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 484 z1= 1 -.600831696075118E-02 0.000000000000000E+00 z1= 2 -.556404003045421E-04 0.000000000000000E+00 z1= 3 -.554345663749024E-04 0.000000000000000E+00 alpha(00000484)=0.000000000000000E+00 beta (00000485)=0.129628339517491E+02 gamma(00000485)=0.129628339517491E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12467E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 485 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000485)=0.000000000000000E+00 beta (00000486)=0.135271224373377E+02 gamma(00000486)=0.135271224373377E+02 lr_calc_dens: Charge drift due to real space implementation = 0.53936E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 486 z1= 1 0.602728675194158E-02 0.000000000000000E+00 z1= 2 0.550148644006317E-04 0.000000000000000E+00 z1= 3 0.554210158269348E-04 0.000000000000000E+00 alpha(00000486)=0.000000000000000E+00 beta (00000487)=0.130399322661134E+02 gamma(00000487)=0.130399322661134E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.18466E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 487 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000487)=0.000000000000000E+00 beta (00000488)=0.134862138794934E+02 gamma(00000488)=0.134862138794934E+02 lr_calc_dens: Charge drift due to real space implementation = 0.16299E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 488 z1= 1 -.606667469312000E-02 0.000000000000000E+00 z1= 2 -.539519525337758E-04 0.000000000000000E+00 z1= 3 -.557989147816961E-04 0.000000000000000E+00 alpha(00000488)=0.000000000000000E+00 beta (00000489)=0.129800206490405E+02 gamma(00000489)=0.129800206490405E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12338E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 489 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000489)=0.000000000000000E+00 beta (00000490)=0.133592629832051E+02 gamma(00000490)=0.133592629832051E+02 lr_calc_dens: Charge drift due to real space implementation = -0.19443E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 490 z1= 1 0.618342248660546E-02 0.000000000000000E+00 z1= 2 0.529466711487216E-04 0.000000000000000E+00 z1= 3 0.559387905232156E-04 0.000000000000000E+00 alpha(00000490)=0.000000000000000E+00 beta (00000491)=0.130733528533521E+02 gamma(00000491)=0.130733528533521E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.21287E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 491 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000491)=0.000000000000000E+00 beta (00000492)=0.135433759731360E+02 gamma(00000492)=0.135433759731360E+02 lr_calc_dens: Charge drift due to real space implementation = 0.26541E-11 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 492 z1= 1 -.626047378708397E-02 0.000000000000000E+00 z1= 2 -.525130599463609E-04 0.000000000000000E+00 z1= 3 -.554637910899204E-04 0.000000000000000E+00 alpha(00000492)=0.000000000000000E+00 beta (00000493)=0.129918960751961E+02 gamma(00000493)=0.129918960751961E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.25371E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 493 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000493)=0.000000000000000E+00 beta (00000494)=0.135855864381742E+02 gamma(00000494)=0.135855864381742E+02 lr_calc_dens: Charge drift due to real space implementation = 0.19380E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 494 z1= 1 0.631741771389487E-02 0.000000000000000E+00 z1= 2 0.515535695810830E-04 0.000000000000000E+00 z1= 3 0.545623549091554E-04 0.000000000000000E+00 alpha(00000494)=0.000000000000000E+00 beta (00000495)=0.130262568019869E+02 gamma(00000495)=0.130262568019869E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11371E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 495 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000495)=0.000000000000000E+00 beta (00000496)=0.134925383095805E+02 gamma(00000496)=0.134925383095805E+02 lr_calc_dens: Charge drift due to real space implementation = -0.22592E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 496 z1= 1 -.656821578293469E-02 0.000000000000000E+00 z1= 2 -.494567890848251E-04 0.000000000000000E+00 z1= 3 -.542067643426869E-04 0.000000000000000E+00 alpha(00000496)=0.000000000000000E+00 beta (00000497)=0.129792886929471E+02 gamma(00000497)=0.129792886929471E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.60576E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 497 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000497)=0.000000000000000E+00 beta (00000498)=0.135253063308444E+02 gamma(00000498)=0.135253063308444E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10183E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 498 z1= 1 0.684948507361770E-02 0.000000000000000E+00 z1= 2 0.474846505953627E-04 0.000000000000000E+00 z1= 3 0.534191986585299E-04 0.000000000000000E+00 alpha(00000498)=0.000000000000000E+00 beta (00000499)=0.130288210784425E+02 gamma(00000499)=0.130288210784425E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.16737E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 499 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000499)=0.000000000000000E+00 beta (00000500)=0.134995477553868E+02 gamma(00000500)=0.134995477553868E+02 lr_calc_dens: Charge drift due to real space implementation = 0.15568E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 500 z1= 1 -.712767708639225E-02 0.000000000000000E+00 z1= 2 -.444798403060453E-04 0.000000000000000E+00 z1= 3 -.529504028691629E-04 0.000000000000000E+00 alpha(00000500)=0.000000000000000E+00 beta (00000501)=0.129663973006772E+02 gamma(00000501)=0.129663973006772E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14835E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 501 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000501)=0.000000000000000E+00 beta (00000502)=0.135150655888975E+02 gamma(00000502)=0.135150655888975E+02 lr_calc_dens: Charge drift due to real space implementation = -0.18471E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 502 z1= 1 0.729194127452450E-02 0.000000000000000E+00 z1= 2 0.419537207730939E-04 0.000000000000000E+00 z1= 3 0.521871026896021E-04 0.000000000000000E+00 alpha(00000502)=0.000000000000000E+00 beta (00000503)=0.129552783222331E+02 gamma(00000503)=0.129552783222331E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.21517E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 503 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000503)=0.000000000000000E+00 beta (00000504)=0.134402281908958E+02 gamma(00000504)=0.134402281908958E+02 lr_calc_dens: Charge drift due to real space implementation = 0.13437E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 504 z1= 1 -.742457589094899E-02 0.000000000000000E+00 z1= 2 -.385373419274733E-04 0.000000000000000E+00 z1= 3 -.520000972901454E-04 0.000000000000000E+00 alpha(00000504)=0.000000000000000E+00 beta (00000505)=0.130234281540088E+02 gamma(00000505)=0.130234281540088E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.22097E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 505 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000505)=0.000000000000000E+00 beta (00000506)=0.135021702320866E+02 gamma(00000506)=0.135021702320866E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12402E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 506 z1= 1 0.747591248811106E-02 0.000000000000000E+00 z1= 2 0.361426858904498E-04 0.000000000000000E+00 z1= 3 0.516921543845056E-04 0.000000000000000E+00 alpha(00000506)=0.000000000000000E+00 beta (00000507)=0.130131696572199E+02 gamma(00000507)=0.130131696572199E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11560E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 507 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000507)=0.000000000000000E+00 beta (00000508)=0.135052983047892E+02 gamma(00000508)=0.135052983047892E+02 lr_calc_dens: Charge drift due to real space implementation = -0.15086E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 508 z1= 1 -.747588392417560E-02 0.000000000000000E+00 z1= 2 -.370407437552591E-04 0.000000000000000E+00 z1= 3 -.513407677920787E-04 0.000000000000000E+00 alpha(00000508)=0.000000000000000E+00 beta (00000509)=0.129917717201445E+02 gamma(00000509)=0.129917717201445E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.45028E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 509 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000509)=0.000000000000000E+00 beta (00000510)=0.135298766709464E+02 gamma(00000510)=0.135298766709464E+02 lr_calc_dens: Charge drift due to real space implementation = 0.17527E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 510 z1= 1 0.751537675551152E-02 0.000000000000000E+00 z1= 2 0.379550401913807E-04 0.000000000000000E+00 z1= 3 0.514643737202206E-04 0.000000000000000E+00 alpha(00000510)=0.000000000000000E+00 beta (00000511)=0.129600829542026E+02 gamma(00000511)=0.129600829542026E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.62093E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 511 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000511)=0.000000000000000E+00 beta (00000512)=0.135319877712450E+02 gamma(00000512)=0.135319877712450E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11977E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 512 z1= 1 -.766104809020135E-02 0.000000000000000E+00 z1= 2 -.368341849209773E-04 0.000000000000000E+00 z1= 3 -.517013518451260E-04 0.000000000000000E+00 alpha(00000512)=0.000000000000000E+00 beta (00000513)=0.129994461120854E+02 gamma(00000513)=0.129994461120854E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.15585E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 513 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000513)=0.000000000000000E+00 beta (00000514)=0.135069148609905E+02 gamma(00000514)=0.135069148609905E+02 lr_calc_dens: Charge drift due to real space implementation = -0.80635E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 514 z1= 1 0.783957742448675E-02 0.000000000000000E+00 z1= 2 0.361241085337569E-04 0.000000000000000E+00 z1= 3 0.523568433073952E-04 0.000000000000000E+00 alpha(00000514)=0.000000000000000E+00 beta (00000515)=0.130093290222180E+02 gamma(00000515)=0.130093290222180E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.87600E-10 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 515 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000515)=0.000000000000000E+00 beta (00000516)=0.134835615599008E+02 gamma(00000516)=0.134835615599008E+02 lr_calc_dens: Charge drift due to real space implementation = 0.50234E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 516 z1= 1 -.791555679552756E-02 0.000000000000000E+00 z1= 2 -.335875923215094E-04 0.000000000000000E+00 z1= 3 -.533416120687060E-04 0.000000000000000E+00 alpha(00000516)=0.000000000000000E+00 beta (00000517)=0.130221396435428E+02 gamma(00000517)=0.130221396435428E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.62890E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 517 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000517)=0.000000000000000E+00 beta (00000518)=0.135905673124700E+02 gamma(00000518)=0.135905673124700E+02 lr_calc_dens: Charge drift due to real space implementation = -0.13926E-10 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 518 z1= 1 0.785489073788729E-02 0.000000000000000E+00 z1= 2 0.320592433089859E-04 0.000000000000000E+00 z1= 3 0.538447686118228E-04 0.000000000000000E+00 alpha(00000518)=0.000000000000000E+00 beta (00000519)=0.129941019782233E+02 gamma(00000519)=0.129941019782233E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.16339E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 519 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000519)=0.000000000000000E+00 beta (00000520)=0.134650990865820E+02 gamma(00000520)=0.134650990865820E+02 lr_calc_dens: Charge drift due to real space implementation = 0.87002E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 520 z1= 1 -.783390477545128E-02 0.000000000000000E+00 z1= 2 -.300872507983220E-04 0.000000000000000E+00 z1= 3 -.548971610528529E-04 0.000000000000000E+00 alpha(00000520)=0.000000000000000E+00 beta (00000521)=0.129390457975363E+02 gamma(00000521)=0.129390457975363E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14100E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 521 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000521)=0.000000000000000E+00 beta (00000522)=0.136044511944770E+02 gamma(00000522)=0.136044511944770E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11131E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 522 z1= 1 0.765811970325317E-02 0.000000000000000E+00 z1= 2 0.292136735797980E-04 0.000000000000000E+00 z1= 3 0.554457894707755E-04 0.000000000000000E+00 alpha(00000522)=0.000000000000000E+00 beta (00000523)=0.128959757568868E+02 gamma(00000523)=0.128959757568868E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.15758E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 523 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000523)=0.000000000000000E+00 beta (00000524)=0.134790771974135E+02 gamma(00000524)=0.134790771974135E+02 lr_calc_dens: Charge drift due to real space implementation = -0.17514E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 524 z1= 1 -.748627017114419E-02 0.000000000000000E+00 z1= 2 -.295742145391561E-04 0.000000000000000E+00 z1= 3 -.565087742761277E-04 0.000000000000000E+00 alpha(00000524)=0.000000000000000E+00 beta (00000525)=0.129958206338401E+02 gamma(00000525)=0.129958206338401E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.52799E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 525 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000525)=0.000000000000000E+00 beta (00000526)=0.134871076653999E+02 gamma(00000526)=0.134871076653999E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11195E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 526 z1= 1 0.730112214191140E-02 0.000000000000000E+00 z1= 2 0.296103337035737E-04 0.000000000000000E+00 z1= 3 0.577347632960529E-04 0.000000000000000E+00 alpha(00000526)=0.000000000000000E+00 beta (00000527)=0.130065428013263E+02 gamma(00000527)=0.130065428013263E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.16318E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 527 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000527)=0.000000000000000E+00 beta (00000528)=0.135457586463241E+02 gamma(00000528)=0.135457586463241E+02 lr_calc_dens: Charge drift due to real space implementation = 0.33848E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 528 z1= 1 -.710104750850317E-02 0.000000000000000E+00 z1= 2 -.286426467409049E-04 0.000000000000000E+00 z1= 3 -.579971509860035E-04 0.000000000000000E+00 alpha(00000528)=0.000000000000000E+00 beta (00000529)=0.130718445184396E+02 gamma(00000529)=0.130718445184396E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10049E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 529 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000529)=0.000000000000000E+00 beta (00000530)=0.135056897133739E+02 gamma(00000530)=0.135056897133739E+02 lr_calc_dens: Charge drift due to real space implementation = -0.91861E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 530 z1= 1 0.696837594993273E-02 0.000000000000000E+00 z1= 2 0.283922641481182E-04 0.000000000000000E+00 z1= 3 0.588038066150922E-04 0.000000000000000E+00 alpha(00000530)=0.000000000000000E+00 beta (00000531)=0.131085588250472E+02 gamma(00000531)=0.131085588250472E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.32639E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 531 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000531)=0.000000000000000E+00 beta (00000532)=0.134655256779022E+02 gamma(00000532)=0.134655256779022E+02 lr_calc_dens: Charge drift due to real space implementation = 0.16915E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 532 z1= 1 -.679735178644001E-02 0.000000000000000E+00 z1= 2 -.271219318455627E-04 0.000000000000000E+00 z1= 3 -.606178891918998E-04 0.000000000000000E+00 alpha(00000532)=0.000000000000000E+00 beta (00000533)=0.130302102106215E+02 gamma(00000533)=0.130302102106215E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14241E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 533 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000533)=0.000000000000000E+00 beta (00000534)=0.134481073258564E+02 gamma(00000534)=0.134481073258564E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10620E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 534 z1= 1 0.657227364374682E-02 0.000000000000000E+00 z1= 2 0.257190456382757E-04 0.000000000000000E+00 z1= 3 0.627829130873070E-04 0.000000000000000E+00 alpha(00000534)=0.000000000000000E+00 beta (00000535)=0.130719418480350E+02 gamma(00000535)=0.130719418480350E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.26848E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 535 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000535)=0.000000000000000E+00 beta (00000536)=0.136065186767519E+02 gamma(00000536)=0.136065186767519E+02 lr_calc_dens: Charge drift due to real space implementation = -0.72398E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 536 z1= 1 -.632001060112361E-02 0.000000000000000E+00 z1= 2 -.243713029848746E-04 0.000000000000000E+00 z1= 3 -.646484572266348E-04 0.000000000000000E+00 alpha(00000536)=0.000000000000000E+00 beta (00000537)=0.130257597710498E+02 gamma(00000537)=0.130257597710498E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.17462E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 537 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000537)=0.000000000000000E+00 beta (00000538)=0.135685240072004E+02 gamma(00000538)=0.135685240072004E+02 lr_calc_dens: Charge drift due to real space implementation = 0.95313E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 538 z1= 1 0.603398883370444E-02 0.000000000000000E+00 z1= 2 0.222240015219401E-04 0.000000000000000E+00 z1= 3 0.663606132594872E-04 0.000000000000000E+00 alpha(00000538)=0.000000000000000E+00 beta (00000539)=0.129726528335478E+02 gamma(00000539)=0.129726528335478E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.69311E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 539 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000539)=0.000000000000000E+00 beta (00000540)=0.135681534201597E+02 gamma(00000540)=0.135681534201597E+02 lr_calc_dens: Charge drift due to real space implementation = -0.41899E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 540 z1= 1 -.575973211780817E-02 0.000000000000000E+00 z1= 2 -.221651287056982E-04 0.000000000000000E+00 z1= 3 -.676901998141264E-04 0.000000000000000E+00 alpha(00000540)=0.000000000000000E+00 beta (00000541)=0.130282561767399E+02 gamma(00000541)=0.130282561767399E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.21196E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 541 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000541)=0.000000000000000E+00 beta (00000542)=0.135296224798882E+02 gamma(00000542)=0.135296224798882E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10685E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 542 z1= 1 0.563464496237040E-02 0.000000000000000E+00 z1= 2 0.219228567037233E-04 0.000000000000000E+00 z1= 3 0.692710037766454E-04 0.000000000000000E+00 alpha(00000542)=0.000000000000000E+00 beta (00000543)=0.129008326710080E+02 gamma(00000543)=0.129008326710080E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.98572E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 543 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000543)=0.000000000000000E+00 beta (00000544)=0.135303913833324E+02 gamma(00000544)=0.135303913833324E+02 lr_calc_dens: Charge drift due to real space implementation = 0.68227E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 544 z1= 1 -.551605117421065E-02 0.000000000000000E+00 z1= 2 -.206355152966313E-04 0.000000000000000E+00 z1= 3 -.697942108134178E-04 0.000000000000000E+00 alpha(00000544)=0.000000000000000E+00 beta (00000545)=0.129541745000800E+02 gamma(00000545)=0.129541745000800E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.18680E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 545 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000545)=0.000000000000000E+00 beta (00000546)=0.134753810687615E+02 gamma(00000546)=0.134753810687615E+02 lr_calc_dens: Charge drift due to real space implementation = 0.87209E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 546 z1= 1 0.535241050170345E-02 0.000000000000000E+00 z1= 2 0.201143173823898E-04 0.000000000000000E+00 z1= 3 0.710301858527068E-04 0.000000000000000E+00 alpha(00000546)=0.000000000000000E+00 beta (00000547)=0.130078789671364E+02 gamma(00000547)=0.130078789671364E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.82273E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 547 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000547)=0.000000000000000E+00 beta (00000548)=0.134574629880134E+02 gamma(00000548)=0.134574629880134E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10790E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 548 z1= 1 -.505336227716797E-02 0.000000000000000E+00 z1= 2 -.232579013319254E-04 0.000000000000000E+00 z1= 3 -.729908628170784E-04 0.000000000000000E+00 alpha(00000548)=0.000000000000000E+00 beta (00000549)=0.129278557237215E+02 gamma(00000549)=0.129278557237215E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.34571E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 549 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000549)=0.000000000000000E+00 beta (00000550)=0.135311908354538E+02 gamma(00000550)=0.135311908354538E+02 lr_calc_dens: Charge drift due to real space implementation = -0.31270E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 550 z1= 1 0.454757151925123E-02 0.000000000000000E+00 z1= 2 0.269147107560984E-04 0.000000000000000E+00 z1= 3 0.743518832391745E-04 0.000000000000000E+00 alpha(00000550)=0.000000000000000E+00 beta (00000551)=0.129727155815125E+02 gamma(00000551)=0.129727155815125E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.38512E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 551 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000551)=0.000000000000000E+00 beta (00000552)=0.135506940576913E+02 gamma(00000552)=0.135506940576913E+02 lr_calc_dens: Charge drift due to real space implementation = 0.94384E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 552 z1= 1 -.396913765054490E-02 0.000000000000000E+00 z1= 2 -.283507278177114E-04 0.000000000000000E+00 z1= 3 -.761545894254055E-04 0.000000000000000E+00 alpha(00000552)=0.000000000000000E+00 beta (00000553)=0.129920736876417E+02 gamma(00000553)=0.129920736876417E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.17518E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 553 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000553)=0.000000000000000E+00 beta (00000554)=0.135384918006608E+02 gamma(00000554)=0.135384918006608E+02 lr_calc_dens: Charge drift due to real space implementation = -0.15731E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 554 z1= 1 0.351652798364007E-02 0.000000000000000E+00 z1= 2 0.296495354226360E-04 0.000000000000000E+00 z1= 3 0.781349989172479E-04 0.000000000000000E+00 alpha(00000554)=0.000000000000000E+00 beta (00000555)=0.129374080178303E+02 gamma(00000555)=0.129374080178303E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.17803E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 555 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000555)=0.000000000000000E+00 beta (00000556)=0.135463297020571E+02 gamma(00000556)=0.135463297020571E+02 lr_calc_dens: Charge drift due to real space implementation = -0.25089E-10 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 556 z1= 1 -.323254850395324E-02 0.000000000000000E+00 z1= 2 -.316934348109608E-04 0.000000000000000E+00 z1= 3 -.797640214580685E-04 0.000000000000000E+00 alpha(00000556)=0.000000000000000E+00 beta (00000557)=0.130298529105395E+02 gamma(00000557)=0.130298529105395E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.15145E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 557 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000557)=0.000000000000000E+00 beta (00000558)=0.134769951867448E+02 gamma(00000558)=0.134769951867448E+02 lr_calc_dens: Charge drift due to real space implementation = -0.52367E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 558 z1= 1 0.316485313751930E-02 0.000000000000000E+00 z1= 2 0.321554078228207E-04 0.000000000000000E+00 z1= 3 0.819191956832592E-04 0.000000000000000E+00 alpha(00000558)=0.000000000000000E+00 beta (00000559)=0.129645560940372E+02 gamma(00000559)=0.129645560940372E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.20518E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 559 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000559)=0.000000000000000E+00 beta (00000560)=0.134836730807537E+02 gamma(00000560)=0.134836730807537E+02 lr_calc_dens: Charge drift due to real space implementation = 0.54291E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 560 z1= 1 -.325396901856978E-02 0.000000000000000E+00 z1= 2 -.303285350443400E-04 0.000000000000000E+00 z1= 3 -.836684474723519E-04 0.000000000000000E+00 alpha(00000560)=0.000000000000000E+00 beta (00000561)=0.130424491710403E+02 gamma(00000561)=0.130424491710403E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.25175E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 561 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000561)=0.000000000000000E+00 beta (00000562)=0.135007610901881E+02 gamma(00000562)=0.135007610901881E+02 lr_calc_dens: Charge drift due to real space implementation = -0.26569E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 562 z1= 1 0.341704039787043E-02 0.000000000000000E+00 z1= 2 0.294615525454791E-04 0.000000000000000E+00 z1= 3 0.855783737052306E-04 0.000000000000000E+00 alpha(00000562)=0.000000000000000E+00 beta (00000563)=0.130413125316957E+02 gamma(00000563)=0.130413125316957E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.27505E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 563 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000563)=0.000000000000000E+00 beta (00000564)=0.136290153950675E+02 gamma(00000564)=0.136290153950675E+02 lr_calc_dens: Charge drift due to real space implementation = 0.22173E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 564 z1= 1 -.344617844560217E-02 0.000000000000000E+00 z1= 2 -.290142342105665E-04 0.000000000000000E+00 z1= 3 -.858691156604523E-04 0.000000000000000E+00 alpha(00000564)=0.000000000000000E+00 beta (00000565)=0.130218046391254E+02 gamma(00000565)=0.130218046391254E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.36183E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 565 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000565)=0.000000000000000E+00 beta (00000566)=0.135604889782819E+02 gamma(00000566)=0.135604889782819E+02 lr_calc_dens: Charge drift due to real space implementation = 0.69350E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 566 z1= 1 0.337164139015857E-02 0.000000000000000E+00 z1= 2 0.313731795220712E-04 0.000000000000000E+00 z1= 3 0.862239298797365E-04 0.000000000000000E+00 alpha(00000566)=0.000000000000000E+00 beta (00000567)=0.130576250479597E+02 gamma(00000567)=0.130576250479597E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.42708E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 567 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000567)=0.000000000000000E+00 beta (00000568)=0.135964930943654E+02 gamma(00000568)=0.135964930943654E+02 lr_calc_dens: Charge drift due to real space implementation = -0.30697E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 568 z1= 1 -.328233864228196E-02 0.000000000000000E+00 z1= 2 -.347747358946837E-04 0.000000000000000E+00 z1= 3 -.865903998651348E-04 0.000000000000000E+00 alpha(00000568)=0.000000000000000E+00 beta (00000569)=0.128815105829700E+02 gamma(00000569)=0.128815105829700E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.22242E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 569 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000569)=0.000000000000000E+00 beta (00000570)=0.135915398435704E+02 gamma(00000570)=0.135915398435704E+02 lr_calc_dens: Charge drift due to real space implementation = 0.34471E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 570 z1= 1 0.320816074997252E-02 0.000000000000000E+00 z1= 2 0.353620032597843E-04 0.000000000000000E+00 z1= 3 0.856806628043254E-04 0.000000000000000E+00 alpha(00000570)=0.000000000000000E+00 beta (00000571)=0.129280056332419E+02 gamma(00000571)=0.129280056332419E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.34749E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 571 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000571)=0.000000000000000E+00 beta (00000572)=0.136809555167536E+02 gamma(00000572)=0.136809555167536E+02 lr_calc_dens: Charge drift due to real space implementation = -0.13722E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 572 z1= 1 -.316229142027755E-02 0.000000000000000E+00 z1= 2 -.367970268462122E-04 0.000000000000000E+00 z1= 3 -.838912575379278E-04 0.000000000000000E+00 alpha(00000572)=0.000000000000000E+00 beta (00000573)=0.130460539896495E+02 gamma(00000573)=0.130460539896495E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.46833E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 573 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000573)=0.000000000000000E+00 beta (00000574)=0.135374800100414E+02 gamma(00000574)=0.135374800100414E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11969E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 574 z1= 1 0.322703879368239E-02 0.000000000000000E+00 z1= 2 0.387306980211702E-04 0.000000000000000E+00 z1= 3 0.828765283697407E-04 0.000000000000000E+00 alpha(00000574)=0.000000000000000E+00 beta (00000575)=0.129232710299202E+02 gamma(00000575)=0.129232710299202E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.33257E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 575 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000575)=0.000000000000000E+00 beta (00000576)=0.134363801400407E+02 gamma(00000576)=0.134363801400407E+02 lr_calc_dens: Charge drift due to real space implementation = 0.16493E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 576 z1= 1 -.343257806382117E-02 0.000000000000000E+00 z1= 2 -.406147327881392E-04 0.000000000000000E+00 z1= 3 -.813603286656372E-04 0.000000000000000E+00 alpha(00000576)=0.000000000000000E+00 beta (00000577)=0.129456079796874E+02 gamma(00000577)=0.129456079796874E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.19064E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 577 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000577)=0.000000000000000E+00 beta (00000578)=0.136051972208287E+02 gamma(00000578)=0.136051972208287E+02 lr_calc_dens: Charge drift due to real space implementation = -0.98392E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 578 z1= 1 0.380880195191618E-02 0.000000000000000E+00 z1= 2 0.433637397616159E-04 0.000000000000000E+00 z1= 3 0.791425174569164E-04 0.000000000000000E+00 alpha(00000578)=0.000000000000000E+00 beta (00000579)=0.128894045950544E+02 gamma(00000579)=0.128894045950544E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.32397E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 579 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000579)=0.000000000000000E+00 beta (00000580)=0.135192965137440E+02 gamma(00000580)=0.135192965137440E+02 lr_calc_dens: Charge drift due to real space implementation = -0.19158E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 580 z1= 1 -.435989662424605E-02 0.000000000000000E+00 z1= 2 -.451394186061519E-04 0.000000000000000E+00 z1= 3 -.772953054003407E-04 0.000000000000000E+00 alpha(00000580)=0.000000000000000E+00 beta (00000581)=0.129594405215911E+02 gamma(00000581)=0.129594405215911E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.36498E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 581 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000581)=0.000000000000000E+00 beta (00000582)=0.134681233470196E+02 gamma(00000582)=0.134681233470196E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11131E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 582 z1= 1 0.494167403897424E-02 0.000000000000000E+00 z1= 2 0.443609406547635E-04 0.000000000000000E+00 z1= 3 0.769067422008125E-04 0.000000000000000E+00 alpha(00000582)=0.000000000000000E+00 beta (00000583)=0.129591768251479E+02 gamma(00000583)=0.129591768251479E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.40458E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 583 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000583)=0.000000000000000E+00 beta (00000584)=0.134901583869084E+02 gamma(00000584)=0.134901583869084E+02 lr_calc_dens: Charge drift due to real space implementation = -0.29709E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 584 z1= 1 -.536769932686345E-02 0.000000000000000E+00 z1= 2 -.436700839786227E-04 0.000000000000000E+00 z1= 3 -.769692288209852E-04 0.000000000000000E+00 alpha(00000584)=0.000000000000000E+00 beta (00000585)=0.129895234326897E+02 gamma(00000585)=0.129895234326897E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.25499E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 585 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000585)=0.000000000000000E+00 beta (00000586)=0.135355739813983E+02 gamma(00000586)=0.135355739813983E+02 lr_calc_dens: Charge drift due to real space implementation = 0.36440E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 586 z1= 1 0.554170861833752E-02 0.000000000000000E+00 z1= 2 0.447305816898744E-04 0.000000000000000E+00 z1= 3 0.771141637401234E-04 0.000000000000000E+00 alpha(00000586)=0.000000000000000E+00 beta (00000587)=0.130093423991134E+02 gamma(00000587)=0.130093423991134E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.17627E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 587 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000587)=0.000000000000000E+00 beta (00000588)=0.135310195582316E+02 gamma(00000588)=0.135310195582316E+02 lr_calc_dens: Charge drift due to real space implementation = -0.15008E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 588 z1= 1 -.561365580492064E-02 0.000000000000000E+00 z1= 2 -.437971853044289E-04 0.000000000000000E+00 z1= 3 -.778316166817721E-04 0.000000000000000E+00 alpha(00000588)=0.000000000000000E+00 beta (00000589)=0.130285240370185E+02 gamma(00000589)=0.130285240370185E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.30654E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 589 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000589)=0.000000000000000E+00 beta (00000590)=0.135225654855885E+02 gamma(00000590)=0.135225654855885E+02 lr_calc_dens: Charge drift due to real space implementation = 0.28482E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 590 z1= 1 0.573264549471522E-02 0.000000000000000E+00 z1= 2 0.434377460529173E-04 0.000000000000000E+00 z1= 3 0.793914923025799E-04 0.000000000000000E+00 alpha(00000590)=0.000000000000000E+00 beta (00000591)=0.130286939572832E+02 gamma(00000591)=0.130286939572832E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.30999E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 591 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000591)=0.000000000000000E+00 beta (00000592)=0.134347294071540E+02 gamma(00000592)=0.134347294071540E+02 lr_calc_dens: Charge drift due to real space implementation = -0.13229E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 592 z1= 1 -.595185244129215E-02 0.000000000000000E+00 z1= 2 -.468350179109681E-04 0.000000000000000E+00 z1= 3 -.818727479013080E-04 0.000000000000000E+00 alpha(00000592)=0.000000000000000E+00 beta (00000593)=0.129922634550252E+02 gamma(00000593)=0.129922634550252E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.54787E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 593 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000593)=0.000000000000000E+00 beta (00000594)=0.135244787885291E+02 gamma(00000594)=0.135244787885291E+02 lr_calc_dens: Charge drift due to real space implementation = -0.36990E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 594 z1= 1 0.618285604452392E-02 0.000000000000000E+00 z1= 2 0.471361972447619E-04 0.000000000000000E+00 z1= 3 0.836367157034294E-04 0.000000000000000E+00 alpha(00000594)=0.000000000000000E+00 beta (00000595)=0.130354600259357E+02 gamma(00000595)=0.130354600259357E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.18385E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 595 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000595)=0.000000000000000E+00 beta (00000596)=0.134508423785378E+02 gamma(00000596)=0.134508423785378E+02 lr_calc_dens: Charge drift due to real space implementation = -0.73182E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 596 z1= 1 -.652499623035854E-02 0.000000000000000E+00 z1= 2 -.466590539085921E-04 0.000000000000000E+00 z1= 3 -.863576851118036E-04 0.000000000000000E+00 alpha(00000596)=0.000000000000000E+00 beta (00000597)=0.128940801815495E+02 gamma(00000597)=0.128940801815495E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14603E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 597 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000597)=0.000000000000000E+00 beta (00000598)=0.136076232043122E+02 gamma(00000598)=0.136076232043122E+02 lr_calc_dens: Charge drift due to real space implementation = 0.81261E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 598 z1= 1 0.665477476831162E-02 0.000000000000000E+00 z1= 2 0.430446109643892E-04 0.000000000000000E+00 z1= 3 0.873774876760279E-04 0.000000000000000E+00 alpha(00000598)=0.000000000000000E+00 beta (00000599)=0.129496100217265E+02 gamma(00000599)=0.129496100217265E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10309E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 599 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000599)=0.000000000000000E+00 beta (00000600)=0.134553572377276E+02 gamma(00000600)=0.134553572377276E+02 lr_calc_dens: Charge drift due to real space implementation = -0.25561E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 600 z1= 1 -.664261989398970E-02 0.000000000000000E+00 z1= 2 -.419291748252615E-04 0.000000000000000E+00 z1= 3 -.892421706671496E-04 0.000000000000000E+00 alpha(00000600)=0.000000000000000E+00 beta (00000601)=0.129794629412980E+02 gamma(00000601)=0.129794629412980E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.11561E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 601 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000601)=0.000000000000000E+00 beta (00000602)=0.134640709906378E+02 gamma(00000602)=0.134640709906378E+02 lr_calc_dens: Charge drift due to real space implementation = -0.32409E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 602 z1= 1 0.640830205806915E-02 0.000000000000000E+00 z1= 2 0.412278126268092E-04 0.000000000000000E+00 z1= 3 0.906652916618580E-04 0.000000000000000E+00 alpha(00000602)=0.000000000000000E+00 beta (00000603)=0.130221859530850E+02 gamma(00000603)=0.130221859530850E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.19040E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 603 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000603)=0.000000000000000E+00 beta (00000604)=0.135555983360634E+02 gamma(00000604)=0.135555983360634E+02 lr_calc_dens: Charge drift due to real space implementation = 0.52718E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 604 z1= 1 -.593690868986891E-02 0.000000000000000E+00 z1= 2 -.395707300400753E-04 0.000000000000000E+00 z1= 3 -.913587313946252E-04 0.000000000000000E+00 alpha(00000604)=0.000000000000000E+00 beta (00000605)=0.129336488046278E+02 gamma(00000605)=0.129336488046278E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.31134E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 605 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000605)=0.000000000000000E+00 beta (00000606)=0.135374381109318E+02 gamma(00000606)=0.135374381109318E+02 lr_calc_dens: Charge drift due to real space implementation = 0.22859E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 606 z1= 1 0.532663534977298E-02 0.000000000000000E+00 z1= 2 0.391648528594024E-04 0.000000000000000E+00 z1= 3 0.915366921467285E-04 0.000000000000000E+00 alpha(00000606)=0.000000000000000E+00 beta (00000607)=0.129933899219253E+02 gamma(00000607)=0.129933899219253E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.37218E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 607 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000607)=0.000000000000000E+00 beta (00000608)=0.134603439897881E+02 gamma(00000608)=0.134603439897881E+02 lr_calc_dens: Charge drift due to real space implementation = -0.13738E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 608 z1= 1 -.476915512794468E-02 0.000000000000000E+00 z1= 2 -.398169620310753E-04 0.000000000000000E+00 z1= 3 -.925821459342422E-04 0.000000000000000E+00 alpha(00000608)=0.000000000000000E+00 beta (00000609)=0.129650439626135E+02 gamma(00000609)=0.129650439626135E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.33274E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 609 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000609)=0.000000000000000E+00 beta (00000610)=0.135721171667041E+02 gamma(00000610)=0.135721171667041E+02 lr_calc_dens: Charge drift due to real space implementation = 0.19120E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 610 z1= 1 0.416790162234809E-02 0.000000000000000E+00 z1= 2 0.372047231792256E-04 0.000000000000000E+00 z1= 3 0.930096502910454E-04 0.000000000000000E+00 alpha(00000610)=0.000000000000000E+00 beta (00000611)=0.130161744541203E+02 gamma(00000611)=0.130161744541203E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.25386E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 611 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000611)=0.000000000000000E+00 beta (00000612)=0.134515505185704E+02 gamma(00000612)=0.134515505185704E+02 lr_calc_dens: Charge drift due to real space implementation = -0.17913E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 612 z1= 1 -.378977893627309E-02 0.000000000000000E+00 z1= 2 -.370177218863941E-04 0.000000000000000E+00 z1= 3 -.951225918326055E-04 0.000000000000000E+00 alpha(00000612)=0.000000000000000E+00 beta (00000613)=0.130064855744085E+02 gamma(00000613)=0.130064855744085E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.19232E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 613 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000613)=0.000000000000000E+00 beta (00000614)=0.136213638370794E+02 gamma(00000614)=0.136213638370794E+02 lr_calc_dens: Charge drift due to real space implementation = 0.16967E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 614 z1= 1 0.353899614796255E-02 0.000000000000000E+00 z1= 2 0.376438263165455E-04 0.000000000000000E+00 z1= 3 0.962944954598815E-04 0.000000000000000E+00 alpha(00000614)=0.000000000000000E+00 beta (00000615)=0.129020768231515E+02 gamma(00000615)=0.129020768231515E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.71714E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 615 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000615)=0.000000000000000E+00 beta (00000616)=0.135088242778897E+02 gamma(00000616)=0.135088242778897E+02 lr_calc_dens: Charge drift due to real space implementation = -0.16817E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 616 z1= 1 -.333496355328842E-02 0.000000000000000E+00 z1= 2 -.365496594149153E-04 0.000000000000000E+00 z1= 3 -.977929094966370E-04 0.000000000000000E+00 alpha(00000616)=0.000000000000000E+00 beta (00000617)=0.130554871267823E+02 gamma(00000617)=0.130554871267823E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10431E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 617 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000617)=0.000000000000000E+00 beta (00000618)=0.134898972302782E+02 gamma(00000618)=0.134898972302782E+02 lr_calc_dens: Charge drift due to real space implementation = -0.75768E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 618 z1= 1 0.299348127523144E-02 0.000000000000000E+00 z1= 2 0.354082433829628E-04 0.000000000000000E+00 z1= 3 0.100643623325041E-03 0.000000000000000E+00 alpha(00000618)=0.000000000000000E+00 beta (00000619)=0.130894093984161E+02 gamma(00000619)=0.130894093984161E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.23227E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 619 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000619)=0.000000000000000E+00 beta (00000620)=0.135143501318598E+02 gamma(00000620)=0.135143501318598E+02 lr_calc_dens: Charge drift due to real space implementation = 0.39136E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 620 z1= 1 -.237809093314009E-02 0.000000000000000E+00 z1= 2 -.345650293915453E-04 0.000000000000000E+00 z1= 3 -.103437482617544E-03 0.000000000000000E+00 alpha(00000620)=0.000000000000000E+00 beta (00000621)=0.129448142105972E+02 gamma(00000621)=0.129448142105972E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.34811E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 621 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000621)=0.000000000000000E+00 beta (00000622)=0.134549531649700E+02 gamma(00000622)=0.134549531649700E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11040E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 622 z1= 1 0.163123651533147E-02 0.000000000000000E+00 z1= 2 0.324067908320331E-04 0.000000000000000E+00 z1= 3 0.105709170078939E-03 0.000000000000000E+00 alpha(00000622)=0.000000000000000E+00 beta (00000623)=0.129614148974358E+02 gamma(00000623)=0.129614148974358E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.31030E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 623 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000623)=0.000000000000000E+00 beta (00000624)=0.134865562203861E+02 gamma(00000624)=0.134865562203861E+02 lr_calc_dens: Charge drift due to real space implementation = -0.17677E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 624 z1= 1 -.960655701828881E-03 0.000000000000000E+00 z1= 2 -.317400680952332E-04 0.000000000000000E+00 z1= 3 -.108172278454664E-03 0.000000000000000E+00 alpha(00000624)=0.000000000000000E+00 beta (00000625)=0.129564383447141E+02 gamma(00000625)=0.129564383447141E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.23501E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 625 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000625)=0.000000000000000E+00 beta (00000626)=0.134876021644795E+02 gamma(00000626)=0.134876021644795E+02 lr_calc_dens: Charge drift due to real space implementation = 0.19138E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 626 z1= 1 0.480638642173573E-03 0.000000000000000E+00 z1= 2 0.347933993502768E-04 0.000000000000000E+00 z1= 3 0.110901921068464E-03 0.000000000000000E+00 alpha(00000626)=0.000000000000000E+00 beta (00000627)=0.130030651083486E+02 gamma(00000627)=0.130030651083486E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.74098E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 627 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000627)=0.000000000000000E+00 beta (00000628)=0.134394381135342E+02 gamma(00000628)=0.134394381135342E+02 lr_calc_dens: Charge drift due to real space implementation = 0.29253E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 628 z1= 1 -.222200615551236E-03 0.000000000000000E+00 z1= 2 -.341850462287907E-04 0.000000000000000E+00 z1= 3 -.114463725256336E-03 0.000000000000000E+00 alpha(00000628)=0.000000000000000E+00 beta (00000629)=0.130308275548204E+02 gamma(00000629)=0.130308275548204E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.17873E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 629 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000629)=0.000000000000000E+00 beta (00000630)=0.134892895260520E+02 gamma(00000630)=0.134892895260520E+02 lr_calc_dens: Charge drift due to real space implementation = -0.13518E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 630 z1= 1 0.739605706974577E-04 0.000000000000000E+00 z1= 2 0.347527611288005E-04 0.000000000000000E+00 z1= 3 0.118025328343133E-03 0.000000000000000E+00 alpha(00000630)=0.000000000000000E+00 beta (00000631)=0.129973229074545E+02 gamma(00000631)=0.129973229074545E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.44476E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 631 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000631)=0.000000000000000E+00 beta (00000632)=0.134891166196179E+02 gamma(00000632)=0.134891166196179E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10664E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 632 z1= 1 0.595394361877846E-04 0.000000000000000E+00 z1= 2 -.348276866983859E-04 0.000000000000000E+00 z1= 3 -.121438492274654E-03 0.000000000000000E+00 alpha(00000632)=0.000000000000000E+00 beta (00000633)=0.130888310059446E+02 gamma(00000633)=0.130888310059446E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.36548E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 633 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000633)=0.000000000000000E+00 beta (00000634)=0.135018636265442E+02 gamma(00000634)=0.135018636265442E+02 lr_calc_dens: Charge drift due to real space implementation = 0.14042E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 634 z1= 1 -.171782743048991E-03 0.000000000000000E+00 z1= 2 0.337593174630857E-04 0.000000000000000E+00 z1= 3 0.125453996682211E-03 0.000000000000000E+00 alpha(00000634)=0.000000000000000E+00 beta (00000635)=0.130114569852733E+02 gamma(00000635)=0.130114569852733E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.31007E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 635 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000635)=0.000000000000000E+00 beta (00000636)=0.135599709788676E+02 gamma(00000636)=0.135599709788676E+02 lr_calc_dens: Charge drift due to real space implementation = -0.87595E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 636 z1= 1 0.219638732214871E-03 0.000000000000000E+00 z1= 2 -.350126740788510E-04 0.000000000000000E+00 z1= 3 -.127800444635260E-03 0.000000000000000E+00 alpha(00000636)=0.000000000000000E+00 beta (00000637)=0.130519929083834E+02 gamma(00000637)=0.130519929083834E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.34225E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 637 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000637)=0.000000000000000E+00 beta (00000638)=0.135535826757194E+02 gamma(00000638)=0.135535826757194E+02 lr_calc_dens: Charge drift due to real space implementation = 0.96358E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 638 z1= 1 -.229657544350064E-03 0.000000000000000E+00 z1= 2 0.363429872231261E-04 0.000000000000000E+00 z1= 3 0.130314478883917E-03 0.000000000000000E+00 alpha(00000638)=0.000000000000000E+00 beta (00000639)=0.128914187905920E+02 gamma(00000639)=0.128914187905920E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.31682E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 639 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000639)=0.000000000000000E+00 beta (00000640)=0.135160132948324E+02 gamma(00000640)=0.135160132948324E+02 lr_calc_dens: Charge drift due to real space implementation = -0.52176E-10 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 640 z1= 1 0.273989208165857E-03 0.000000000000000E+00 z1= 2 -.359607309484418E-04 0.000000000000000E+00 z1= 3 -.131615530841344E-03 0.000000000000000E+00 alpha(00000640)=0.000000000000000E+00 beta (00000641)=0.130172597788326E+02 gamma(00000641)=0.130172597788326E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.43690E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 641 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000641)=0.000000000000000E+00 beta (00000642)=0.135270572730046E+02 gamma(00000642)=0.135270572730046E+02 lr_calc_dens: Charge drift due to real space implementation = 0.94418E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 642 z1= 1 -.329680106372672E-03 0.000000000000000E+00 z1= 2 0.357086723862987E-04 0.000000000000000E+00 z1= 3 0.134222206930805E-03 0.000000000000000E+00 alpha(00000642)=0.000000000000000E+00 beta (00000643)=0.130497812202723E+02 gamma(00000643)=0.130497812202723E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.45473E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 643 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000643)=0.000000000000000E+00 beta (00000644)=0.135269883998175E+02 gamma(00000644)=0.135269883998175E+02 lr_calc_dens: Charge drift due to real space implementation = -0.21648E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 644 z1= 1 0.261514658430551E-03 0.000000000000000E+00 z1= 2 -.366858776264345E-04 0.000000000000000E+00 z1= 3 -.136906290755314E-03 0.000000000000000E+00 alpha(00000644)=0.000000000000000E+00 beta (00000645)=0.130275999206427E+02 gamma(00000645)=0.130275999206427E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.37196E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 645 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000645)=0.000000000000000E+00 beta (00000646)=0.134799626776219E+02 gamma(00000646)=0.134799626776219E+02 lr_calc_dens: Charge drift due to real space implementation = 0.25413E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 646 z1= 1 0.144295428080395E-03 0.000000000000000E+00 z1= 2 0.379344486823190E-04 0.000000000000000E+00 z1= 3 0.140306598169089E-03 0.000000000000000E+00 alpha(00000646)=0.000000000000000E+00 beta (00000647)=0.130392855710617E+02 gamma(00000647)=0.130392855710617E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.30155E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 647 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000647)=0.000000000000000E+00 beta (00000648)=0.135165660038949E+02 gamma(00000648)=0.135165660038949E+02 lr_calc_dens: Charge drift due to real space implementation = -0.27687E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 648 z1= 1 -.768966805414261E-03 0.000000000000000E+00 z1= 2 -.394119972398444E-04 0.000000000000000E+00 z1= 3 -.144309691484605E-03 0.000000000000000E+00 alpha(00000648)=0.000000000000000E+00 beta (00000649)=0.130397335605863E+02 gamma(00000649)=0.130397335605863E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.21179E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 649 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000649)=0.000000000000000E+00 beta (00000650)=0.135356078180190E+02 gamma(00000650)=0.135356078180190E+02 lr_calc_dens: Charge drift due to real space implementation = 0.25013E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 650 z1= 1 0.142844345877349E-02 0.000000000000000E+00 z1= 2 0.411219172707874E-04 0.000000000000000E+00 z1= 3 0.149026333539702E-03 0.000000000000000E+00 alpha(00000650)=0.000000000000000E+00 beta (00000651)=0.129709070439290E+02 gamma(00000651)=0.129709070439290E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.14321E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 651 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000651)=0.000000000000000E+00 beta (00000652)=0.135193663525140E+02 gamma(00000652)=0.135193663525140E+02 lr_calc_dens: Charge drift due to real space implementation = -0.18791E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 652 z1= 1 -.205019161019772E-02 0.000000000000000E+00 z1= 2 -.401982630478877E-04 0.000000000000000E+00 z1= 3 -.153496939230469E-03 0.000000000000000E+00 alpha(00000652)=0.000000000000000E+00 beta (00000653)=0.130159897714549E+02 gamma(00000653)=0.130159897714549E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.90244E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 653 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000653)=0.000000000000000E+00 beta (00000654)=0.135482562352959E+02 gamma(00000654)=0.135482562352959E+02 lr_calc_dens: Charge drift due to real space implementation = 0.67281E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 654 z1= 1 0.255783234433530E-02 0.000000000000000E+00 z1= 2 0.383581761417770E-04 0.000000000000000E+00 z1= 3 0.158132827347147E-03 0.000000000000000E+00 alpha(00000654)=0.000000000000000E+00 beta (00000655)=0.129704892180761E+02 gamma(00000655)=0.129704892180761E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12552E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 655 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000655)=0.000000000000000E+00 beta (00000656)=0.135124335256462E+02 gamma(00000656)=0.135124335256462E+02 lr_calc_dens: Charge drift due to real space implementation = 0.26484E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 656 z1= 1 -.294804791208390E-02 0.000000000000000E+00 z1= 2 -.393049686439328E-04 0.000000000000000E+00 z1= 3 -.162561595762540E-03 0.000000000000000E+00 alpha(00000656)=0.000000000000000E+00 beta (00000657)=0.130104512038295E+02 gamma(00000657)=0.130104512038295E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.22415E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 657 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000657)=0.000000000000000E+00 beta (00000658)=0.134867103400223E+02 gamma(00000658)=0.134867103400223E+02 lr_calc_dens: Charge drift due to real space implementation = -0.28492E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 658 z1= 1 0.327376451825193E-02 0.000000000000000E+00 z1= 2 0.399229077132674E-04 0.000000000000000E+00 z1= 3 0.168170865456334E-03 0.000000000000000E+00 alpha(00000658)=0.000000000000000E+00 beta (00000659)=0.130876080238018E+02 gamma(00000659)=0.130876080238018E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.30333E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 659 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000659)=0.000000000000000E+00 beta (00000660)=0.134647612238466E+02 gamma(00000660)=0.134647612238466E+02 lr_calc_dens: Charge drift due to real space implementation = -0.15554E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 660 z1= 1 -.369611287843725E-02 0.000000000000000E+00 z1= 2 -.426444568835289E-04 0.000000000000000E+00 z1= 3 -.174917921327132E-03 0.000000000000000E+00 alpha(00000660)=0.000000000000000E+00 beta (00000661)=0.130393664828273E+02 gamma(00000661)=0.130393664828273E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.34142E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 661 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000661)=0.000000000000000E+00 beta (00000662)=0.134876336024718E+02 gamma(00000662)=0.134876336024718E+02 lr_calc_dens: Charge drift due to real space implementation = 0.41160E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 662 z1= 1 0.419633815017611E-02 0.000000000000000E+00 z1= 2 0.435217312329947E-04 0.000000000000000E+00 z1= 3 0.180885863660198E-03 0.000000000000000E+00 alpha(00000662)=0.000000000000000E+00 beta (00000663)=0.128924813895170E+02 gamma(00000663)=0.128924813895170E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.39331E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 663 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000663)=0.000000000000000E+00 beta (00000664)=0.134864776880592E+02 gamma(00000664)=0.134864776880592E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11393E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 664 z1= 1 -.465133384911512E-02 0.000000000000000E+00 z1= 2 -.460777883949780E-04 0.000000000000000E+00 z1= 3 -.185083328906354E-03 0.000000000000000E+00 alpha(00000664)=0.000000000000000E+00 beta (00000665)=0.130175596909431E+02 gamma(00000665)=0.130175596909431E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.35825E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 665 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000665)=0.000000000000000E+00 beta (00000666)=0.134473822902818E+02 gamma(00000666)=0.134473822902818E+02 lr_calc_dens: Charge drift due to real space implementation = 0.92109E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 666 z1= 1 0.513528201840442E-02 0.000000000000000E+00 z1= 2 0.460944835916511E-04 0.000000000000000E+00 z1= 3 0.191694414900683E-03 0.000000000000000E+00 alpha(00000666)=0.000000000000000E+00 beta (00000667)=0.129239854139870E+02 gamma(00000667)=0.129239854139870E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.40346E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 667 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000667)=0.000000000000000E+00 beta (00000668)=0.134707498804709E+02 gamma(00000668)=0.134707498804709E+02 lr_calc_dens: Charge drift due to real space implementation = -0.90388E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 668 z1= 1 -.537246039424320E-02 0.000000000000000E+00 z1= 2 -.443222732797281E-04 0.000000000000000E+00 z1= 3 -.195974925152944E-03 0.000000000000000E+00 alpha(00000668)=0.000000000000000E+00 beta (00000669)=0.129582310143725E+02 gamma(00000669)=0.129582310143725E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.51516E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 669 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000669)=0.000000000000000E+00 beta (00000670)=0.135474731285395E+02 gamma(00000670)=0.135474731285395E+02 lr_calc_dens: Charge drift due to real space implementation = 0.26790E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 670 z1= 1 0.528367562841732E-02 0.000000000000000E+00 z1= 2 0.447174798169775E-04 0.000000000000000E+00 z1= 3 0.199154224600321E-03 0.000000000000000E+00 alpha(00000670)=0.000000000000000E+00 beta (00000671)=0.130254077311734E+02 gamma(00000671)=0.130254077311734E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.39779E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 671 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000671)=0.000000000000000E+00 beta (00000672)=0.135730873242612E+02 gamma(00000672)=0.135730873242612E+02 lr_calc_dens: Charge drift due to real space implementation = -0.31110E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 672 z1= 1 -.499101604852966E-02 0.000000000000000E+00 z1= 2 -.462531126216702E-04 0.000000000000000E+00 z1= 3 -.202586763827981E-03 0.000000000000000E+00 alpha(00000672)=0.000000000000000E+00 beta (00000673)=0.130536610509279E+02 gamma(00000673)=0.130536610509279E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.20543E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 673 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000673)=0.000000000000000E+00 beta (00000674)=0.135570686525756E+02 gamma(00000674)=0.135570686525756E+02 lr_calc_dens: Charge drift due to real space implementation = 0.13372E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 674 z1= 1 0.457200489756239E-02 0.000000000000000E+00 z1= 2 0.506093761021339E-04 0.000000000000000E+00 z1= 3 0.206385460382539E-03 0.000000000000000E+00 alpha(00000674)=0.000000000000000E+00 beta (00000675)=0.129493091707102E+02 gamma(00000675)=0.129493091707102E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.23179E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 675 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000675)=0.000000000000000E+00 beta (00000676)=0.134232014316468E+02 gamma(00000676)=0.134232014316468E+02 lr_calc_dens: Charge drift due to real space implementation = -0.61375E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 676 z1= 1 -.407625088197868E-02 0.000000000000000E+00 z1= 2 -.535803937011421E-04 0.000000000000000E+00 z1= 3 -.210392218778119E-03 0.000000000000000E+00 alpha(00000676)=0.000000000000000E+00 beta (00000677)=0.130265057093252E+02 gamma(00000677)=0.130265057093252E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.30375E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 677 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000677)=0.000000000000000E+00 beta (00000678)=0.135335082656126E+02 gamma(00000678)=0.135335082656126E+02 lr_calc_dens: Charge drift due to real space implementation = 0.94363E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 678 z1= 1 0.350997221706233E-02 0.000000000000000E+00 z1= 2 0.538626718261728E-04 0.000000000000000E+00 z1= 3 0.213536197924417E-03 0.000000000000000E+00 alpha(00000678)=0.000000000000000E+00 beta (00000679)=0.129927399498155E+02 gamma(00000679)=0.129927399498155E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.30643E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 679 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000679)=0.000000000000000E+00 beta (00000680)=0.134995604790188E+02 gamma(00000680)=0.134995604790188E+02 lr_calc_dens: Charge drift due to real space implementation = -0.90245E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 680 z1= 1 -.282638211408177E-02 0.000000000000000E+00 z1= 2 -.548720789543145E-04 0.000000000000000E+00 z1= 3 -.216625372348722E-03 0.000000000000000E+00 alpha(00000680)=0.000000000000000E+00 beta (00000681)=0.131110458883015E+02 gamma(00000681)=0.131110458883015E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.28170E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 681 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000681)=0.000000000000000E+00 beta (00000682)=0.134910962562482E+02 gamma(00000682)=0.134910962562482E+02 lr_calc_dens: Charge drift due to real space implementation = -0.15949E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 682 z1= 1 0.203322977636344E-02 0.000000000000000E+00 z1= 2 0.560396995582836E-04 0.000000000000000E+00 z1= 3 0.221502114703502E-03 0.000000000000000E+00 alpha(00000682)=0.000000000000000E+00 beta (00000683)=0.130091018481335E+02 gamma(00000683)=0.130091018481335E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.40877E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 683 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000683)=0.000000000000000E+00 beta (00000684)=0.135262720195162E+02 gamma(00000684)=0.135262720195162E+02 lr_calc_dens: Charge drift due to real space implementation = 0.14219E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 684 z1= 1 -.115646904163281E-02 0.000000000000000E+00 z1= 2 -.582185317732787E-04 0.000000000000000E+00 z1= 3 -.223551468908415E-03 0.000000000000000E+00 alpha(00000684)=0.000000000000000E+00 beta (00000685)=0.130854529166879E+02 gamma(00000685)=0.130854529166879E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.51997E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 685 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000685)=0.000000000000000E+00 beta (00000686)=0.134722403656993E+02 gamma(00000686)=0.134722403656993E+02 lr_calc_dens: Charge drift due to real space implementation = 0.36173E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 686 z1= 1 0.392611696228199E-03 0.000000000000000E+00 z1= 2 0.589118861409003E-04 0.000000000000000E+00 z1= 3 0.227565186814483E-03 0.000000000000000E+00 alpha(00000686)=0.000000000000000E+00 beta (00000687)=0.130248833290677E+02 gamma(00000687)=0.130248833290677E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.62044E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 687 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000687)=0.000000000000000E+00 beta (00000688)=0.135962657277438E+02 gamma(00000688)=0.135962657277438E+02 lr_calc_dens: Charge drift due to real space implementation = -0.17043E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 688 z1= 1 0.224758964664340E-03 0.000000000000000E+00 z1= 2 -.585715022130128E-04 0.000000000000000E+00 z1= 3 -.228404916232050E-03 0.000000000000000E+00 alpha(00000688)=0.000000000000000E+00 beta (00000689)=0.131313200433058E+02 gamma(00000689)=0.131313200433058E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.61813E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 689 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000689)=0.000000000000000E+00 beta (00000690)=0.134234582387990E+02 gamma(00000690)=0.134234582387990E+02 lr_calc_dens: Charge drift due to real space implementation = 0.32540E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 690 z1= 1 -.748588953099049E-03 0.000000000000000E+00 z1= 2 0.633958657589636E-04 0.000000000000000E+00 z1= 3 0.234216434412744E-03 0.000000000000000E+00 alpha(00000690)=0.000000000000000E+00 beta (00000691)=0.129758669936800E+02 gamma(00000691)=0.129758669936800E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.43623E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 691 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000691)=0.000000000000000E+00 beta (00000692)=0.135711634266117E+02 gamma(00000692)=0.135711634266117E+02 lr_calc_dens: Charge drift due to real space implementation = -0.27780E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 692 z1= 1 0.121928838385727E-02 0.000000000000000E+00 z1= 2 -.651267678477910E-04 0.000000000000000E+00 z1= 3 -.234266304896920E-03 0.000000000000000E+00 alpha(00000692)=0.000000000000000E+00 beta (00000693)=0.130882398210842E+02 gamma(00000693)=0.130882398210842E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.31504E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 693 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000693)=0.000000000000000E+00 beta (00000694)=0.134025584339632E+02 gamma(00000694)=0.134025584339632E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12275E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 694 z1= 1 -.174041064053565E-02 0.000000000000000E+00 z1= 2 0.659629790267669E-04 0.000000000000000E+00 z1= 3 0.238952255779598E-03 0.000000000000000E+00 alpha(00000694)=0.000000000000000E+00 beta (00000695)=0.130086315073135E+02 gamma(00000695)=0.130086315073135E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.36631E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 695 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000695)=0.000000000000000E+00 beta (00000696)=0.134474366969952E+02 gamma(00000696)=0.134474366969952E+02 lr_calc_dens: Charge drift due to real space implementation = -0.34816E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 696 z1= 1 0.230997226109819E-02 0.000000000000000E+00 z1= 2 -.670702850106841E-04 0.000000000000000E+00 z1= 3 -.241150795448496E-03 0.000000000000000E+00 alpha(00000696)=0.000000000000000E+00 beta (00000697)=0.131120482202276E+02 gamma(00000697)=0.131120482202276E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.48898E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 697 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000697)=0.000000000000000E+00 beta (00000698)=0.135291266959125E+02 gamma(00000698)=0.135291266959125E+02 lr_calc_dens: Charge drift due to real space implementation = 0.60690E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 698 z1= 1 -.300029009925952E-02 0.000000000000000E+00 z1= 2 0.709347771681822E-04 0.000000000000000E+00 z1= 3 0.243684187565173E-03 0.000000000000000E+00 alpha(00000698)=0.000000000000000E+00 beta (00000699)=0.130068757166389E+02 gamma(00000699)=0.130068757166389E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.55313E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 699 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000699)=0.000000000000000E+00 beta (00000700)=0.134612348775528E+02 gamma(00000700)=0.134612348775528E+02 lr_calc_dens: Charge drift due to real space implementation = -0.86165E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 700 z1= 1 0.383344140566500E-02 0.000000000000000E+00 z1= 2 -.724637764385541E-04 0.000000000000000E+00 z1= 3 -.245883214515611E-03 0.000000000000000E+00 alpha(00000700)=0.000000000000000E+00 beta (00000701)=0.130099949148116E+02 gamma(00000701)=0.130099949148116E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.57435E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 701 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000701)=0.000000000000000E+00 beta (00000702)=0.134434200876031E+02 gamma(00000702)=0.134434200876031E+02 lr_calc_dens: Charge drift due to real space implementation = 0.40166E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 702 z1= 1 -.474409026369828E-02 0.000000000000000E+00 z1= 2 0.730439114568528E-04 0.000000000000000E+00 z1= 3 0.249247600036393E-03 0.000000000000000E+00 alpha(00000702)=0.000000000000000E+00 beta (00000703)=0.130586499297711E+02 gamma(00000703)=0.130586499297711E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.69938E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 703 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000703)=0.000000000000000E+00 beta (00000704)=0.134793363842224E+02 gamma(00000704)=0.134793363842224E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11375E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 704 z1= 1 0.552089947508042E-02 0.000000000000000E+00 z1= 2 -.762068302493308E-04 0.000000000000000E+00 z1= 3 -.253410358965750E-03 0.000000000000000E+00 alpha(00000704)=0.000000000000000E+00 beta (00000705)=0.130505750589066E+02 gamma(00000705)=0.130505750589066E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.77617E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 705 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000705)=0.000000000000000E+00 beta (00000706)=0.134988313312690E+02 gamma(00000706)=0.134988313312690E+02 lr_calc_dens: Charge drift due to real space implementation = 0.24280E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 706 z1= 1 -.611151201754372E-02 0.000000000000000E+00 z1= 2 0.802971209294054E-04 0.000000000000000E+00 z1= 3 0.257563722918479E-03 0.000000000000000E+00 alpha(00000706)=0.000000000000000E+00 beta (00000707)=0.130491850576804E+02 gamma(00000707)=0.130491850576804E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.75776E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 707 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000707)=0.000000000000000E+00 beta (00000708)=0.133681187831962E+02 gamma(00000708)=0.133681187831962E+02 lr_calc_dens: Charge drift due to real space implementation = -0.35601E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 708 z1= 1 0.662331384354395E-02 0.000000000000000E+00 z1= 2 -.830656670850220E-04 0.000000000000000E+00 z1= 3 -.264160823995929E-03 0.000000000000000E+00 alpha(00000708)=0.000000000000000E+00 beta (00000709)=0.129859063056074E+02 gamma(00000709)=0.129859063056074E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.63276E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 709 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000709)=0.000000000000000E+00 beta (00000710)=0.134091587630690E+02 gamma(00000710)=0.134091587630690E+02 lr_calc_dens: Charge drift due to real space implementation = 0.34736E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 710 z1= 1 -.693253854515914E-02 0.000000000000000E+00 z1= 2 0.846032485645972E-04 0.000000000000000E+00 z1= 3 0.268080206342759E-03 0.000000000000000E+00 alpha(00000710)=0.000000000000000E+00 beta (00000711)=0.130443273863370E+02 gamma(00000711)=0.130443273863370E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.56180E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 711 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000711)=0.000000000000000E+00 beta (00000712)=0.135388367406500E+02 gamma(00000712)=0.135388367406500E+02 lr_calc_dens: Charge drift due to real space implementation = -0.33368E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 712 z1= 1 0.710463038508768E-02 0.000000000000000E+00 z1= 2 -.855521562839892E-04 0.000000000000000E+00 z1= 3 -.269887484410755E-03 0.000000000000000E+00 alpha(00000712)=0.000000000000000E+00 beta (00000713)=0.130451842128653E+02 gamma(00000713)=0.130451842128653E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.51382E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 713 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000713)=0.000000000000000E+00 beta (00000714)=0.135034720499151E+02 gamma(00000714)=0.135034720499151E+02 lr_calc_dens: Charge drift due to real space implementation = 0.34342E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 714 z1= 1 -.718041944147058E-02 0.000000000000000E+00 z1= 2 0.878117009516710E-04 0.000000000000000E+00 z1= 3 0.272257040276612E-03 0.000000000000000E+00 alpha(00000714)=0.000000000000000E+00 beta (00000715)=0.131055250759310E+02 gamma(00000715)=0.131055250759310E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.35525E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 715 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000715)=0.000000000000000E+00 beta (00000716)=0.134550460636329E+02 gamma(00000716)=0.134550460636329E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11599E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 716 z1= 1 0.719506223923087E-02 0.000000000000000E+00 z1= 2 -.917191953100252E-04 0.000000000000000E+00 z1= 3 -.276497722704972E-03 0.000000000000000E+00 alpha(00000716)=0.000000000000000E+00 beta (00000717)=0.131021001206521E+02 gamma(00000717)=0.131021001206521E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.50785E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 717 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000717)=0.000000000000000E+00 beta (00000718)=0.135010763949289E+02 gamma(00000718)=0.135010763949289E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12196E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 718 z1= 1 -.716796796645426E-02 0.000000000000000E+00 z1= 2 0.950662909132045E-04 0.000000000000000E+00 z1= 3 0.280191439816792E-03 0.000000000000000E+00 alpha(00000718)=0.000000000000000E+00 beta (00000719)=0.131024320487881E+02 gamma(00000719)=0.131024320487881E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.62631E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 719 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000719)=0.000000000000000E+00 beta (00000720)=0.134129199721600E+02 gamma(00000720)=0.134129199721600E+02 lr_calc_dens: Charge drift due to real space implementation = -0.27052E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 720 z1= 1 0.716940601191545E-02 0.000000000000000E+00 z1= 2 -.970278901973372E-04 0.000000000000000E+00 z1= 3 -.285770771003871E-03 0.000000000000000E+00 alpha(00000720)=0.000000000000000E+00 beta (00000721)=0.130887132280407E+02 gamma(00000721)=0.130887132280407E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.50338E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 721 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000721)=0.000000000000000E+00 beta (00000722)=0.134966133596793E+02 gamma(00000722)=0.134966133596793E+02 lr_calc_dens: Charge drift due to real space implementation = 0.16533E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 722 z1= 1 -.700517290230631E-02 0.000000000000000E+00 z1= 2 0.994981755645143E-04 0.000000000000000E+00 z1= 3 0.288406532955454E-03 0.000000000000000E+00 alpha(00000722)=0.000000000000000E+00 beta (00000723)=0.131578156008974E+02 gamma(00000723)=0.131578156008974E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.56667E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 723 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000723)=0.000000000000000E+00 beta (00000724)=0.134966251693318E+02 gamma(00000724)=0.134966251693318E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10506E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 724 z1= 1 0.682140649094317E-02 0.000000000000000E+00 z1= 2 -.100798336319768E-03 0.000000000000000E+00 z1= 3 -.291165863642828E-03 0.000000000000000E+00 alpha(00000724)=0.000000000000000E+00 beta (00000725)=0.130852479570297E+02 gamma(00000725)=0.130852479570297E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.75563E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 725 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000725)=0.000000000000000E+00 beta (00000726)=0.134367023885760E+02 gamma(00000726)=0.134367023885760E+02 lr_calc_dens: Charge drift due to real space implementation = 0.26897E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 726 z1= 1 -.661174221261010E-02 0.000000000000000E+00 z1= 2 0.102825989501341E-03 0.000000000000000E+00 z1= 3 0.292889136838602E-03 0.000000000000000E+00 alpha(00000726)=0.000000000000000E+00 beta (00000727)=0.130465876164654E+02 gamma(00000727)=0.130465876164654E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.71812E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 727 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000727)=0.000000000000000E+00 beta (00000728)=0.134766487150837E+02 gamma(00000728)=0.134766487150837E+02 lr_calc_dens: Charge drift due to real space implementation = -0.29445E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 728 z1= 1 0.627528499309731E-02 0.000000000000000E+00 z1= 2 -.103179813848638E-03 0.000000000000000E+00 z1= 3 -.292566626390435E-03 0.000000000000000E+00 alpha(00000728)=0.000000000000000E+00 beta (00000729)=0.130594748529683E+02 gamma(00000729)=0.130594748529683E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.73664E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 729 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000729)=0.000000000000000E+00 beta (00000730)=0.133685947793324E+02 gamma(00000730)=0.133685947793324E+02 lr_calc_dens: Charge drift due to real space implementation = 0.38234E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 730 z1= 1 -.597228141349078E-02 0.000000000000000E+00 z1= 2 0.106144126493218E-03 0.000000000000000E+00 z1= 3 0.294616097985968E-03 0.000000000000000E+00 alpha(00000730)=0.000000000000000E+00 beta (00000731)=0.130911962707921E+02 gamma(00000731)=0.130911962707921E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.67402E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 731 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000731)=0.000000000000000E+00 beta (00000732)=0.134596306534773E+02 gamma(00000732)=0.134596306534773E+02 lr_calc_dens: Charge drift due to real space implementation = -0.45581E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 732 z1= 1 0.573148125683605E-02 0.000000000000000E+00 z1= 2 -.106432173218162E-03 0.000000000000000E+00 z1= 3 -.294472389133222E-03 0.000000000000000E+00 alpha(00000732)=0.000000000000000E+00 beta (00000733)=0.130514882836229E+02 gamma(00000733)=0.130514882836229E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.55380E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 733 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000733)=0.000000000000000E+00 beta (00000734)=0.134079200846126E+02 gamma(00000734)=0.134079200846126E+02 lr_calc_dens: Charge drift due to real space implementation = 0.43019E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 734 z1= 1 -.557853206879053E-02 0.000000000000000E+00 z1= 2 0.107108870724341E-03 0.000000000000000E+00 z1= 3 0.294062508972009E-03 0.000000000000000E+00 alpha(00000734)=0.000000000000000E+00 beta (00000735)=0.130526313105542E+02 gamma(00000735)=0.130526313105542E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.50685E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 735 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000735)=0.000000000000000E+00 beta (00000736)=0.134554823656452E+02 gamma(00000736)=0.134554823656452E+02 lr_calc_dens: Charge drift due to real space implementation = -0.45578E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 736 z1= 1 0.546261470225051E-02 0.000000000000000E+00 z1= 2 -.109174640372339E-03 0.000000000000000E+00 z1= 3 -.292273436188871E-03 0.000000000000000E+00 alpha(00000736)=0.000000000000000E+00 beta (00000737)=0.130876975344166E+02 gamma(00000737)=0.130876975344166E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.35804E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 737 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000737)=0.000000000000000E+00 beta (00000738)=0.134474668942703E+02 gamma(00000738)=0.134474668942703E+02 lr_calc_dens: Charge drift due to real space implementation = 0.34271E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 738 z1= 1 -.551574079580541E-02 0.000000000000000E+00 z1= 2 0.110789277249591E-03 0.000000000000000E+00 z1= 3 0.291900813454267E-03 0.000000000000000E+00 alpha(00000738)=0.000000000000000E+00 beta (00000739)=0.130681893391608E+02 gamma(00000739)=0.130681893391608E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.30215E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 739 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000739)=0.000000000000000E+00 beta (00000740)=0.134112861252229E+02 gamma(00000740)=0.134112861252229E+02 lr_calc_dens: Charge drift due to real space implementation = -0.20318E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 740 z1= 1 0.566422706374443E-02 0.000000000000000E+00 z1= 2 -.114605365003297E-03 0.000000000000000E+00 z1= 3 -.292540328972361E-03 0.000000000000000E+00 alpha(00000740)=0.000000000000000E+00 beta (00000741)=0.130238972009319E+02 gamma(00000741)=0.130238972009319E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.35654E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 741 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000741)=0.000000000000000E+00 beta (00000742)=0.134208815160652E+02 gamma(00000742)=0.134208815160652E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11576E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 742 z1= 1 -.575835619120561E-02 0.000000000000000E+00 z1= 2 0.118436062905371E-03 0.000000000000000E+00 z1= 3 0.292345012308064E-03 0.000000000000000E+00 alpha(00000742)=0.000000000000000E+00 beta (00000743)=0.130558739225381E+02 gamma(00000743)=0.130558739225381E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.44675E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 743 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000743)=0.000000000000000E+00 beta (00000744)=0.134070662578524E+02 gamma(00000744)=0.134070662578524E+02 lr_calc_dens: Charge drift due to real space implementation = -0.45764E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 744 z1= 1 0.578891145996965E-02 0.000000000000000E+00 z1= 2 -.120169367255726E-03 0.000000000000000E+00 z1= 3 -.293738013367312E-03 0.000000000000000E+00 alpha(00000744)=0.000000000000000E+00 beta (00000745)=0.131206357681449E+02 gamma(00000745)=0.131206357681449E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.65072E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 745 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000745)=0.000000000000000E+00 beta (00000746)=0.134297170862558E+02 gamma(00000746)=0.134297170862558E+02 lr_calc_dens: Charge drift due to real space implementation = 0.18571E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 746 z1= 1 -.581774986747818E-02 0.000000000000000E+00 z1= 2 0.121161276758609E-03 0.000000000000000E+00 z1= 3 0.296142976517750E-03 0.000000000000000E+00 alpha(00000746)=0.000000000000000E+00 beta (00000747)=0.131039524360418E+02 gamma(00000747)=0.131039524360418E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.68141E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 747 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000747)=0.000000000000000E+00 beta (00000748)=0.133963286641231E+02 gamma(00000748)=0.133963286641231E+02 lr_calc_dens: Charge drift due to real space implementation = -0.28761E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 748 z1= 1 0.583157443638362E-02 0.000000000000000E+00 z1= 2 -.122497344072035E-03 0.000000000000000E+00 z1= 3 -.298512102792837E-03 0.000000000000000E+00 alpha(00000748)=0.000000000000000E+00 beta (00000749)=0.131689159235718E+02 gamma(00000749)=0.131689159235718E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.63589E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 749 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000749)=0.000000000000000E+00 beta (00000750)=0.134093426900193E+02 gamma(00000750)=0.134093426900193E+02 lr_calc_dens: Charge drift due to real space implementation = 0.32146E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 750 z1= 1 -.570004049541458E-02 0.000000000000000E+00 z1= 2 0.125090082409161E-03 0.000000000000000E+00 z1= 3 0.301833544406759E-03 0.000000000000000E+00 alpha(00000750)=0.000000000000000E+00 beta (00000751)=0.131451191850707E+02 gamma(00000751)=0.131451191850707E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.62495E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 751 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000751)=0.000000000000000E+00 beta (00000752)=0.133978079041121E+02 gamma(00000752)=0.133978079041121E+02 lr_calc_dens: Charge drift due to real space implementation = -0.37538E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 752 z1= 1 0.548143795823257E-02 0.000000000000000E+00 z1= 2 -.127597905084976E-03 0.000000000000000E+00 z1= 3 -.304859887121249E-03 0.000000000000000E+00 alpha(00000752)=0.000000000000000E+00 beta (00000753)=0.130888685031947E+02 gamma(00000753)=0.130888685031947E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.55927E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 753 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000753)=0.000000000000000E+00 beta (00000754)=0.133406935025474E+02 gamma(00000754)=0.133406935025474E+02 lr_calc_dens: Charge drift due to real space implementation = 0.34409E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 754 z1= 1 -.529455220360191E-02 0.000000000000000E+00 z1= 2 0.128686980489527E-03 0.000000000000000E+00 z1= 3 0.307701001319257E-03 0.000000000000000E+00 alpha(00000754)=0.000000000000000E+00 beta (00000755)=0.130691053080874E+02 gamma(00000755)=0.130691053080874E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.58764E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 755 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000755)=0.000000000000000E+00 beta (00000756)=0.133240627806923E+02 gamma(00000756)=0.133240627806923E+02 lr_calc_dens: Charge drift due to real space implementation = -0.42542E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 756 z1= 1 0.515611110976585E-02 0.000000000000000E+00 z1= 2 -.126245756920492E-03 0.000000000000000E+00 z1= 3 -.310262020363767E-03 0.000000000000000E+00 alpha(00000756)=0.000000000000000E+00 beta (00000757)=0.131175054810014E+02 gamma(00000757)=0.131175054810014E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.49467E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 757 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000757)=0.000000000000000E+00 beta (00000758)=0.134303020335464E+02 gamma(00000758)=0.134303020335464E+02 lr_calc_dens: Charge drift due to real space implementation = 0.43606E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 758 z1= 1 -.504708953335904E-02 0.000000000000000E+00 z1= 2 0.124012226178003E-03 0.000000000000000E+00 z1= 3 0.311703165799203E-03 0.000000000000000E+00 alpha(00000758)=0.000000000000000E+00 beta (00000759)=0.131456609930127E+02 gamma(00000759)=0.131456609930127E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.38027E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 759 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000759)=0.000000000000000E+00 beta (00000760)=0.133934805053597E+02 gamma(00000760)=0.133934805053597E+02 lr_calc_dens: Charge drift due to real space implementation = -0.35935E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 760 z1= 1 0.517838733104928E-02 0.000000000000000E+00 z1= 2 -.122148182821134E-03 0.000000000000000E+00 z1= 3 -.314663317382000E-03 0.000000000000000E+00 alpha(00000760)=0.000000000000000E+00 beta (00000761)=0.130508230616005E+02 gamma(00000761)=0.130508230616005E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.32432E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 761 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000761)=0.000000000000000E+00 beta (00000762)=0.133817856008878E+02 gamma(00000762)=0.133817856008878E+02 lr_calc_dens: Charge drift due to real space implementation = 0.23007E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 762 z1= 1 -.542560321779997E-02 0.000000000000000E+00 z1= 2 0.118795900495381E-03 0.000000000000000E+00 z1= 3 0.315550451660255E-03 0.000000000000000E+00 alpha(00000762)=0.000000000000000E+00 beta (00000763)=0.130662223673121E+02 gamma(00000763)=0.130662223673121E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.35612E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 763 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000763)=0.000000000000000E+00 beta (00000764)=0.133766027578030E+02 gamma(00000764)=0.133766027578030E+02 lr_calc_dens: Charge drift due to real space implementation = -0.90292E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 764 z1= 1 0.566606873882447E-02 0.000000000000000E+00 z1= 2 -.116605565995458E-03 0.000000000000000E+00 z1= 3 -.317420700517552E-03 0.000000000000000E+00 alpha(00000764)=0.000000000000000E+00 beta (00000765)=0.130943971244639E+02 gamma(00000765)=0.130943971244639E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.52068E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 765 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000765)=0.000000000000000E+00 beta (00000766)=0.134466119585396E+02 gamma(00000766)=0.134466119585396E+02 lr_calc_dens: Charge drift due to real space implementation = 0.94013E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 766 z1= 1 -.578915986880913E-02 0.000000000000000E+00 z1= 2 0.114323189289736E-03 0.000000000000000E+00 z1= 3 0.318487998394941E-03 0.000000000000000E+00 alpha(00000766)=0.000000000000000E+00 beta (00000767)=0.131164082866595E+02 gamma(00000767)=0.131164082866595E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.69112E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 767 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000767)=0.000000000000000E+00 beta (00000768)=0.134044440699313E+02 gamma(00000768)=0.134044440699313E+02 lr_calc_dens: Charge drift due to real space implementation = -0.25730E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 768 z1= 1 0.576371159974665E-02 0.000000000000000E+00 z1= 2 -.113208554263521E-03 0.000000000000000E+00 z1= 3 -.320534534788688E-03 0.000000000000000E+00 alpha(00000768)=0.000000000000000E+00 beta (00000769)=0.131806628236492E+02 gamma(00000769)=0.131806628236492E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.69879E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 769 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000769)=0.000000000000000E+00 beta (00000770)=0.133782575731451E+02 gamma(00000770)=0.133782575731451E+02 lr_calc_dens: Charge drift due to real space implementation = 0.40396E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 770 z1= 1 -.559740286657411E-02 0.000000000000000E+00 z1= 2 0.114245025040188E-03 0.000000000000000E+00 z1= 3 0.324029232993012E-03 0.000000000000000E+00 alpha(00000770)=0.000000000000000E+00 beta (00000771)=0.132231793634039E+02 gamma(00000771)=0.132231793634039E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.60310E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 771 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000771)=0.000000000000000E+00 beta (00000772)=0.134589113894867E+02 gamma(00000772)=0.134589113894867E+02 lr_calc_dens: Charge drift due to real space implementation = -0.46354E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 772 z1= 1 0.544646512528700E-02 0.000000000000000E+00 z1= 2 -.114007049303992E-03 0.000000000000000E+00 z1= 3 -.325697628354216E-03 0.000000000000000E+00 alpha(00000772)=0.000000000000000E+00 beta (00000773)=0.131639991719891E+02 gamma(00000773)=0.131639991719891E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.48196E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 773 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000773)=0.000000000000000E+00 beta (00000774)=0.133943298031280E+02 gamma(00000774)=0.133943298031280E+02 lr_calc_dens: Charge drift due to real space implementation = 0.41182E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 774 z1= 1 -.546258398786006E-02 0.000000000000000E+00 z1= 2 0.110571360283498E-03 0.000000000000000E+00 z1= 3 0.326827398321381E-03 0.000000000000000E+00 alpha(00000774)=0.000000000000000E+00 beta (00000775)=0.131607032461749E+02 gamma(00000775)=0.131607032461749E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.46753E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 775 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000775)=0.000000000000000E+00 beta (00000776)=0.133730034615351E+02 gamma(00000776)=0.133730034615351E+02 lr_calc_dens: Charge drift due to real space implementation = -0.42585E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 776 z1= 1 0.565886508113628E-02 0.000000000000000E+00 z1= 2 -.111212125986474E-03 0.000000000000000E+00 z1= 3 -.327804123383413E-03 0.000000000000000E+00 alpha(00000776)=0.000000000000000E+00 beta (00000777)=0.131622052406316E+02 gamma(00000777)=0.131622052406316E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.40044E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 777 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000777)=0.000000000000000E+00 beta (00000778)=0.133420778955905E+02 gamma(00000778)=0.133420778955905E+02 lr_calc_dens: Charge drift due to real space implementation = 0.38072E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 778 z1= 1 -.593399868953758E-02 0.000000000000000E+00 z1= 2 0.111621449540121E-03 0.000000000000000E+00 z1= 3 0.329096653808876E-03 0.000000000000000E+00 alpha(00000778)=0.000000000000000E+00 beta (00000779)=0.131448317836133E+02 gamma(00000779)=0.131448317836133E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.31245E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 779 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000779)=0.000000000000000E+00 beta (00000780)=0.133625642301010E+02 gamma(00000780)=0.133625642301010E+02 lr_calc_dens: Charge drift due to real space implementation = -0.16305E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 780 z1= 1 0.619275497251416E-02 0.000000000000000E+00 z1= 2 -.109880822582894E-03 0.000000000000000E+00 z1= 3 -.329402268559313E-03 0.000000000000000E+00 alpha(00000780)=0.000000000000000E+00 beta (00000781)=0.131221151946841E+02 gamma(00000781)=0.131221151946841E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.52066E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 781 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000781)=0.000000000000000E+00 beta (00000782)=0.132560558639071E+02 gamma(00000782)=0.132560558639071E+02 lr_calc_dens: Charge drift due to real space implementation = 0.22050E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 782 z1= 1 -.639739409865072E-02 0.000000000000000E+00 z1= 2 0.108222974907771E-03 0.000000000000000E+00 z1= 3 0.332106689677169E-03 0.000000000000000E+00 alpha(00000782)=0.000000000000000E+00 beta (00000783)=0.131993831436814E+02 gamma(00000783)=0.131993831436814E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.61047E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 783 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000783)=0.000000000000000E+00 beta (00000784)=0.133367922749319E+02 gamma(00000784)=0.133367922749319E+02 lr_calc_dens: Charge drift due to real space implementation = -0.36049E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 784 z1= 1 0.646652291281761E-02 0.000000000000000E+00 z1= 2 -.106580280220382E-03 0.000000000000000E+00 z1= 3 -.335073016925871E-03 0.000000000000000E+00 alpha(00000784)=0.000000000000000E+00 beta (00000785)=0.131575200664710E+02 gamma(00000785)=0.131575200664710E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.52732E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 785 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000785)=0.000000000000000E+00 beta (00000786)=0.133549359641917E+02 gamma(00000786)=0.133549359641917E+02 lr_calc_dens: Charge drift due to real space implementation = 0.38409E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 786 z1= 1 -.634887326856870E-02 0.000000000000000E+00 z1= 2 0.103885479267962E-03 0.000000000000000E+00 z1= 3 0.336403524622457E-03 0.000000000000000E+00 alpha(00000786)=0.000000000000000E+00 beta (00000787)=0.130770795701855E+02 gamma(00000787)=0.130770795701855E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.45810E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 787 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000787)=0.000000000000000E+00 beta (00000788)=0.132933714909781E+02 gamma(00000788)=0.132933714909781E+02 lr_calc_dens: Charge drift due to real space implementation = -0.34918E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 788 z1= 1 0.602927990631767E-02 0.000000000000000E+00 z1= 2 -.100934433334339E-03 0.000000000000000E+00 z1= 3 -.336993302950623E-03 0.000000000000000E+00 alpha(00000788)=0.000000000000000E+00 beta (00000789)=0.132127675533898E+02 gamma(00000789)=0.132127675533898E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.45771E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 789 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000789)=0.000000000000000E+00 beta (00000790)=0.133015989001951E+02 gamma(00000790)=0.133015989001951E+02 lr_calc_dens: Charge drift due to real space implementation = 0.33857E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 790 z1= 1 -.578799424785796E-02 0.000000000000000E+00 z1= 2 0.987197956120109E-04 0.000000000000000E+00 z1= 3 0.339851309239639E-03 0.000000000000000E+00 alpha(00000790)=0.000000000000000E+00 beta (00000791)=0.131288940308054E+02 gamma(00000791)=0.131288940308054E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.53136E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 791 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000791)=0.000000000000000E+00 beta (00000792)=0.133330038176706E+02 gamma(00000792)=0.133330038176706E+02 lr_calc_dens: Charge drift due to real space implementation = -0.47483E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 792 z1= 1 0.558730521760218E-02 0.000000000000000E+00 z1= 2 -.993788534029167E-04 0.000000000000000E+00 z1= 3 -.338726781336150E-03 0.000000000000000E+00 alpha(00000792)=0.000000000000000E+00 beta (00000793)=0.131989671491052E+02 gamma(00000793)=0.131989671491052E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.44770E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 793 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000793)=0.000000000000000E+00 beta (00000794)=0.133503794415265E+02 gamma(00000794)=0.133503794415265E+02 lr_calc_dens: Charge drift due to real space implementation = 0.52827E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 794 z1= 1 -.542263484490496E-02 0.000000000000000E+00 z1= 2 0.964865878253316E-04 0.000000000000000E+00 z1= 3 0.338018856940734E-03 0.000000000000000E+00 alpha(00000794)=0.000000000000000E+00 beta (00000795)=0.131318052784384E+02 gamma(00000795)=0.131318052784384E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.35226E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 795 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000795)=0.000000000000000E+00 beta (00000796)=0.133909316041628E+02 gamma(00000796)=0.133909316041628E+02 lr_calc_dens: Charge drift due to real space implementation = -0.53476E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 796 z1= 1 0.514079480405612E-02 0.000000000000000E+00 z1= 2 -.935162397617140E-04 0.000000000000000E+00 z1= 3 -.334472223684967E-03 0.000000000000000E+00 alpha(00000796)=0.000000000000000E+00 beta (00000797)=0.130267117681571E+02 gamma(00000797)=0.130267117681571E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.25588E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 797 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000797)=0.000000000000000E+00 beta (00000798)=0.134381596733617E+02 gamma(00000798)=0.134381596733617E+02 lr_calc_dens: Charge drift due to real space implementation = 0.47391E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 798 z1= 1 -.486058553179585E-02 0.000000000000000E+00 z1= 2 0.895907890136423E-04 0.000000000000000E+00 z1= 3 0.326728215964914E-03 0.000000000000000E+00 alpha(00000798)=0.000000000000000E+00 beta (00000799)=0.131553533451063E+02 gamma(00000799)=0.131553533451063E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.18814E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 799 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000799)=0.000000000000000E+00 beta (00000800)=0.133994525122050E+02 gamma(00000800)=0.133994525122050E+02 lr_calc_dens: Charge drift due to real space implementation = -0.35829E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 800 z1= 1 0.476608248818325E-02 0.000000000000000E+00 z1= 2 -.855422513697740E-04 0.000000000000000E+00 z1= 3 -.323000833028555E-03 0.000000000000000E+00 alpha(00000800)=0.000000000000000E+00 beta (00000801)=0.131488196123074E+02 gamma(00000801)=0.131488196123074E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.20528E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 801 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000801)=0.000000000000000E+00 beta (00000802)=0.134321915183368E+02 gamma(00000802)=0.134321915183368E+02 lr_calc_dens: Charge drift due to real space implementation = 0.28275E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 802 z1= 1 -.470708574618801E-02 0.000000000000000E+00 z1= 2 0.840162158628928E-04 0.000000000000000E+00 z1= 3 0.318032466004620E-03 0.000000000000000E+00 alpha(00000802)=0.000000000000000E+00 beta (00000803)=0.131097786076371E+02 gamma(00000803)=0.131097786076371E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.25810E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 803 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000803)=0.000000000000000E+00 beta (00000804)=0.133663795078414E+02 gamma(00000804)=0.133663795078414E+02 lr_calc_dens: Charge drift due to real space implementation = -0.26545E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 804 z1= 1 0.456676324294835E-02 0.000000000000000E+00 z1= 2 -.822970313154418E-04 0.000000000000000E+00 z1= 3 -.313613926501164E-03 0.000000000000000E+00 alpha(00000804)=0.000000000000000E+00 beta (00000805)=0.131819968003285E+02 gamma(00000805)=0.131819968003285E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.29176E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 805 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000805)=0.000000000000000E+00 beta (00000806)=0.134575397106177E+02 gamma(00000806)=0.134575397106177E+02 lr_calc_dens: Charge drift due to real space implementation = 0.26126E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 806 z1= 1 -.417384842862908E-02 0.000000000000000E+00 z1= 2 0.799529660444904E-04 0.000000000000000E+00 z1= 3 0.308432587693315E-03 0.000000000000000E+00 alpha(00000806)=0.000000000000000E+00 beta (00000807)=0.131606555438741E+02 gamma(00000807)=0.131606555438741E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.33938E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 807 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000807)=0.000000000000000E+00 beta (00000808)=0.133290734778226E+02 gamma(00000808)=0.133290734778226E+02 lr_calc_dens: Charge drift due to real space implementation = -0.29579E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 808 z1= 1 0.356517909669222E-02 0.000000000000000E+00 z1= 2 -.757455686859771E-04 0.000000000000000E+00 z1= 3 -.304981692287289E-03 0.000000000000000E+00 alpha(00000808)=0.000000000000000E+00 beta (00000809)=0.131014209402000E+02 gamma(00000809)=0.131014209402000E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.39841E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 809 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000809)=0.000000000000000E+00 beta (00000810)=0.134286643283907E+02 gamma(00000810)=0.134286643283907E+02 lr_calc_dens: Charge drift due to real space implementation = 0.43921E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 810 z1= 1 -.282387780568616E-02 0.000000000000000E+00 z1= 2 0.713741941124526E-04 0.000000000000000E+00 z1= 3 0.297166295760126E-03 0.000000000000000E+00 alpha(00000810)=0.000000000000000E+00 beta (00000811)=0.131345886757486E+02 gamma(00000811)=0.131345886757486E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.30069E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 811 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000811)=0.000000000000000E+00 beta (00000812)=0.133647322731623E+02 gamma(00000812)=0.133647322731623E+02 lr_calc_dens: Charge drift due to real space implementation = -0.48896E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 812 z1= 1 0.219804829793844E-02 0.000000000000000E+00 z1= 2 -.660238097617699E-04 0.000000000000000E+00 z1= 3 -.291411646956099E-03 0.000000000000000E+00 alpha(00000812)=0.000000000000000E+00 beta (00000813)=0.130839549232502E+02 gamma(00000813)=0.130839549232502E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.20706E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 813 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000813)=0.000000000000000E+00 beta (00000814)=0.133645672816999E+02 gamma(00000814)=0.133645672816999E+02 lr_calc_dens: Charge drift due to real space implementation = 0.50463E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 814 z1= 1 -.164802401379903E-02 0.000000000000000E+00 z1= 2 0.600915914325591E-04 0.000000000000000E+00 z1= 3 0.284767695453693E-03 0.000000000000000E+00 alpha(00000814)=0.000000000000000E+00 beta (00000815)=0.130830389036880E+02 gamma(00000815)=0.130830389036880E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10641E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 815 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000815)=0.000000000000000E+00 beta (00000816)=0.133434606870393E+02 gamma(00000816)=0.133434606870393E+02 lr_calc_dens: Charge drift due to real space implementation = -0.46282E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 816 z1= 1 0.115267345080090E-02 0.000000000000000E+00 z1= 2 -.569520828344067E-04 0.000000000000000E+00 z1= 3 -.278435711334951E-03 0.000000000000000E+00 alpha(00000816)=0.000000000000000E+00 beta (00000817)=0.130899724746070E+02 gamma(00000817)=0.130899724746070E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.57638E-10 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 817 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000817)=0.000000000000000E+00 beta (00000818)=0.134088750914602E+02 gamma(00000818)=0.134088750914602E+02 lr_calc_dens: Charge drift due to real space implementation = 0.32736E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 818 z1= 1 -.725063919550763E-03 0.000000000000000E+00 z1= 2 0.529618552023992E-04 0.000000000000000E+00 z1= 3 0.270397730097877E-03 0.000000000000000E+00 alpha(00000818)=0.000000000000000E+00 beta (00000819)=0.131412163518666E+02 gamma(00000819)=0.131412163518666E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.84652E-10 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 819 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000819)=0.000000000000000E+00 beta (00000820)=0.133656060848914E+02 gamma(00000820)=0.133656060848914E+02 lr_calc_dens: Charge drift due to real space implementation = -0.17747E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 820 z1= 1 0.320678679865629E-03 0.000000000000000E+00 z1= 2 -.459840504597828E-04 0.000000000000000E+00 z1= 3 -.264366025334107E-03 0.000000000000000E+00 alpha(00000820)=0.000000000000000E+00 beta (00000821)=0.130584033442132E+02 gamma(00000821)=0.130584033442132E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10064E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 821 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000821)=0.000000000000000E+00 beta (00000822)=0.134919374413094E+02 gamma(00000822)=0.134919374413094E+02 lr_calc_dens: Charge drift due to real space implementation = 0.13480E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 822 z1= 1 0.374770017710670E-04 0.000000000000000E+00 z1= 2 0.391500480067843E-04 0.000000000000000E+00 z1= 3 0.254436643011311E-03 0.000000000000000E+00 alpha(00000822)=0.000000000000000E+00 beta (00000823)=0.131447829871354E+02 gamma(00000823)=0.131447829871354E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.25808E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 823 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000823)=0.000000000000000E+00 beta (00000824)=0.133946290366728E+02 gamma(00000824)=0.133946290366728E+02 lr_calc_dens: Charge drift due to real space implementation = -0.28106E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 824 z1= 1 -.439464553054370E-03 0.000000000000000E+00 z1= 2 -.360655669351517E-04 0.000000000000000E+00 z1= 3 -.247575448100918E-03 0.000000000000000E+00 alpha(00000824)=0.000000000000000E+00 beta (00000825)=0.130619233223320E+02 gamma(00000825)=0.130619233223320E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.26154E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 825 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000825)=0.000000000000000E+00 beta (00000826)=0.133958323415034E+02 gamma(00000826)=0.133958323415034E+02 lr_calc_dens: Charge drift due to real space implementation = 0.42914E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 826 z1= 1 0.865642052272332E-03 0.000000000000000E+00 z1= 2 0.317412685364397E-04 0.000000000000000E+00 z1= 3 0.238302272022806E-03 0.000000000000000E+00 alpha(00000826)=0.000000000000000E+00 beta (00000827)=0.130646279369131E+02 gamma(00000827)=0.130646279369131E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.16139E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 827 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000827)=0.000000000000000E+00 beta (00000828)=0.134737241239114E+02 gamma(00000828)=0.134737241239114E+02 lr_calc_dens: Charge drift due to real space implementation = -0.51986E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 828 z1= 1 -.122983830868818E-02 0.000000000000000E+00 z1= 2 -.275365394004287E-04 0.000000000000000E+00 z1= 3 -.227309086423073E-03 0.000000000000000E+00 alpha(00000828)=0.000000000000000E+00 beta (00000829)=0.130920125471541E+02 gamma(00000829)=0.130920125471541E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.51628E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 829 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000829)=0.000000000000000E+00 beta (00000830)=0.135343858768504E+02 gamma(00000830)=0.135343858768504E+02 lr_calc_dens: Charge drift due to real space implementation = 0.40118E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 830 z1= 1 0.150989740587912E-02 0.000000000000000E+00 z1= 2 0.228759100799666E-04 0.000000000000000E+00 z1= 3 0.215951703209056E-03 0.000000000000000E+00 alpha(00000830)=0.000000000000000E+00 beta (00000831)=0.131450577048962E+02 gamma(00000831)=0.131450577048962E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.16820E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 831 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000831)=0.000000000000000E+00 beta (00000832)=0.135042471409757E+02 gamma(00000832)=0.135042471409757E+02 lr_calc_dens: Charge drift due to real space implementation = -0.18784E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 832 z1= 1 -.163711218702232E-02 0.000000000000000E+00 z1= 2 -.168229859717241E-04 0.000000000000000E+00 z1= 3 -.205978402109554E-03 0.000000000000000E+00 alpha(00000832)=0.000000000000000E+00 beta (00000833)=0.130819272259619E+02 gamma(00000833)=0.130819272259619E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11732E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 833 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000833)=0.000000000000000E+00 beta (00000834)=0.134729349478128E+02 gamma(00000834)=0.134729349478128E+02 lr_calc_dens: Charge drift due to real space implementation = -0.13528E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 834 z1= 1 0.169741780504861E-02 0.000000000000000E+00 z1= 2 0.114070051747198E-04 0.000000000000000E+00 z1= 3 0.195432588197726E-03 0.000000000000000E+00 alpha(00000834)=0.000000000000000E+00 beta (00000835)=0.130560752738112E+02 gamma(00000835)=0.130560752738112E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.13298E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 835 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000835)=0.000000000000000E+00 beta (00000836)=0.134168002653634E+02 gamma(00000836)=0.134168002653634E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10089E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 836 z1= 1 -.177001269275975E-02 0.000000000000000E+00 z1= 2 -.536889500059225E-05 0.000000000000000E+00 z1= 3 -.185574041891367E-03 0.000000000000000E+00 alpha(00000836)=0.000000000000000E+00 beta (00000837)=0.131123283376304E+02 gamma(00000837)=0.131123283376304E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.36873E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 837 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000837)=0.000000000000000E+00 beta (00000838)=0.133996895429657E+02 gamma(00000838)=0.133996895429657E+02 lr_calc_dens: Charge drift due to real space implementation = 0.29759E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 838 z1= 1 0.185715025358195E-02 0.000000000000000E+00 z1= 2 -.136257148232802E-05 0.000000000000000E+00 z1= 3 0.176573560400690E-03 0.000000000000000E+00 alpha(00000838)=0.000000000000000E+00 beta (00000839)=0.130208174892862E+02 gamma(00000839)=0.130208174892862E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.24859E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 839 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000839)=0.000000000000000E+00 beta (00000840)=0.134556745164610E+02 gamma(00000840)=0.134556745164610E+02 lr_calc_dens: Charge drift due to real space implementation = -0.36930E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 840 z1= 1 -.194925256556900E-02 0.000000000000000E+00 z1= 2 0.728523921113278E-05 0.000000000000000E+00 z1= 3 -.165124468050578E-03 0.000000000000000E+00 alpha(00000840)=0.000000000000000E+00 beta (00000841)=0.131106212082490E+02 gamma(00000841)=0.131106212082490E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.17356E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 841 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000841)=0.000000000000000E+00 beta (00000842)=0.134052732922031E+02 gamma(00000842)=0.134052732922031E+02 lr_calc_dens: Charge drift due to real space implementation = 0.44459E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 842 z1= 1 0.206384843544367E-02 0.000000000000000E+00 z1= 2 -.124279916587332E-04 0.000000000000000E+00 z1= 3 0.155427714748637E-03 0.000000000000000E+00 alpha(00000842)=0.000000000000000E+00 beta (00000843)=0.131063902495353E+02 gamma(00000843)=0.131063902495353E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.45828E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 843 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000843)=0.000000000000000E+00 beta (00000844)=0.134016184236549E+02 gamma(00000844)=0.134016184236549E+02 lr_calc_dens: Charge drift due to real space implementation = -0.48380E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 844 z1= 1 -.212309109203495E-02 0.000000000000000E+00 z1= 2 0.177898558744987E-04 0.000000000000000E+00 z1= 3 -.146778224258466E-03 0.000000000000000E+00 alpha(00000844)=0.000000000000000E+00 beta (00000845)=0.130362851767968E+02 gamma(00000845)=0.130362851767968E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.15727E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 845 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000845)=0.000000000000000E+00 beta (00000846)=0.133837888642514E+02 gamma(00000846)=0.133837888642514E+02 lr_calc_dens: Charge drift due to real space implementation = 0.36858E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 846 z1= 1 0.209870662540465E-02 0.000000000000000E+00 z1= 2 -.202666480598078E-04 0.000000000000000E+00 z1= 3 0.137845518733703E-03 0.000000000000000E+00 alpha(00000846)=0.000000000000000E+00 beta (00000847)=0.131249194620221E+02 gamma(00000847)=0.131249194620221E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.26576E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 847 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000847)=0.000000000000000E+00 beta (00000848)=0.135115651745047E+02 gamma(00000848)=0.135115651745047E+02 lr_calc_dens: Charge drift due to real space implementation = -0.22715E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 848 z1= 1 -.201217595295421E-02 0.000000000000000E+00 z1= 2 0.244961589015488E-04 0.000000000000000E+00 z1= 3 -.128811838580769E-03 0.000000000000000E+00 alpha(00000848)=0.000000000000000E+00 beta (00000849)=0.130515501842405E+02 gamma(00000849)=0.130515501842405E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.32864E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 849 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000849)=0.000000000000000E+00 beta (00000850)=0.133630929704273E+02 gamma(00000850)=0.133630929704273E+02 lr_calc_dens: Charge drift due to real space implementation = -0.26448E-10 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 850 z1= 1 0.198306472887131E-02 0.000000000000000E+00 z1= 2 -.261278482697270E-04 0.000000000000000E+00 z1= 3 0.120223573388032E-03 0.000000000000000E+00 alpha(00000850)=0.000000000000000E+00 beta (00000851)=0.130442510473234E+02 gamma(00000851)=0.130442510473234E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12536E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 851 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000851)=0.000000000000000E+00 beta (00000852)=0.134418824343582E+02 gamma(00000852)=0.134418824343582E+02 lr_calc_dens: Charge drift due to real space implementation = -0.33147E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 852 z1= 1 -.202518792225682E-02 0.000000000000000E+00 z1= 2 0.287696939949966E-04 0.000000000000000E+00 z1= 3 -.111122499234200E-03 0.000000000000000E+00 alpha(00000852)=0.000000000000000E+00 beta (00000853)=0.130729192294218E+02 gamma(00000853)=0.130729192294218E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.33760E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 853 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000853)=0.000000000000000E+00 beta (00000854)=0.133302708638338E+02 gamma(00000854)=0.133302708638338E+02 lr_calc_dens: Charge drift due to real space implementation = 0.93811E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 854 z1= 1 0.219656984384129E-02 0.000000000000000E+00 z1= 2 -.324324406370743E-04 0.000000000000000E+00 z1= 3 0.102928898373356E-03 0.000000000000000E+00 alpha(00000854)=0.000000000000000E+00 beta (00000855)=0.129797651191607E+02 gamma(00000855)=0.129797651191607E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14131E-10 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 855 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000855)=0.000000000000000E+00 beta (00000856)=0.134348692978499E+02 gamma(00000856)=0.134348692978499E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12655E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 856 z1= 1 -.243334785889460E-02 0.000000000000000E+00 z1= 2 0.382764261582505E-04 0.000000000000000E+00 z1= 3 -.922046477155532E-04 0.000000000000000E+00 alpha(00000856)=0.000000000000000E+00 beta (00000857)=0.130754639035739E+02 gamma(00000857)=0.130754639035739E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.38101E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 857 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000857)=0.000000000000000E+00 beta (00000858)=0.134481342720667E+02 gamma(00000858)=0.134481342720667E+02 lr_calc_dens: Charge drift due to real space implementation = 0.18300E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 858 z1= 1 0.271787595912496E-02 0.000000000000000E+00 z1= 2 -.451948929480204E-04 0.000000000000000E+00 z1= 3 0.812043639351597E-04 0.000000000000000E+00 alpha(00000858)=0.000000000000000E+00 beta (00000859)=0.130908328805117E+02 gamma(00000859)=0.130908328805117E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.23603E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 859 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000859)=0.000000000000000E+00 beta (00000860)=0.133065385010571E+02 gamma(00000860)=0.133065385010571E+02 lr_calc_dens: Charge drift due to real space implementation = -0.19847E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 860 z1= 1 -.309970310289628E-02 0.000000000000000E+00 z1= 2 0.510655140277105E-04 0.000000000000000E+00 z1= 3 -.707187002670696E-04 0.000000000000000E+00 alpha(00000860)=0.000000000000000E+00 beta (00000861)=0.130657052495611E+02 gamma(00000861)=0.130657052495611E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.16068E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 861 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000861)=0.000000000000000E+00 beta (00000862)=0.133278184193671E+02 gamma(00000862)=0.133278184193671E+02 lr_calc_dens: Charge drift due to real space implementation = 0.20907E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 862 z1= 1 0.354245007070553E-02 0.000000000000000E+00 z1= 2 -.539677062724201E-04 0.000000000000000E+00 z1= 3 0.595569493183389E-04 0.000000000000000E+00 alpha(00000862)=0.000000000000000E+00 beta (00000863)=0.131640087390649E+02 gamma(00000863)=0.131640087390649E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.28830E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 863 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000863)=0.000000000000000E+00 beta (00000864)=0.134768675872431E+02 gamma(00000864)=0.134768675872431E+02 lr_calc_dens: Charge drift due to real space implementation = -0.27361E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 864 z1= 1 -.399026591173814E-02 0.000000000000000E+00 z1= 2 0.570979978579090E-04 0.000000000000000E+00 z1= 3 -.485557151855909E-04 0.000000000000000E+00 alpha(00000864)=0.000000000000000E+00 beta (00000865)=0.130972766111037E+02 gamma(00000865)=0.130972766111037E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.19126E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 865 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000865)=0.000000000000000E+00 beta (00000866)=0.134666236614676E+02 gamma(00000866)=0.134666236614676E+02 lr_calc_dens: Charge drift due to real space implementation = 0.36783E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 866 z1= 1 0.435048275804997E-02 0.000000000000000E+00 z1= 2 -.596863927768117E-04 0.000000000000000E+00 z1= 3 0.373694030400534E-04 0.000000000000000E+00 alpha(00000866)=0.000000000000000E+00 beta (00000867)=0.130380519181127E+02 gamma(00000867)=0.130380519181127E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.20037E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 867 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000867)=0.000000000000000E+00 beta (00000868)=0.134369833056149E+02 gamma(00000868)=0.134369833056149E+02 lr_calc_dens: Charge drift due to real space implementation = -0.31043E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 868 z1= 1 -.457506103332524E-02 0.000000000000000E+00 z1= 2 0.627595317718348E-04 0.000000000000000E+00 z1= 3 -.263364119168168E-04 0.000000000000000E+00 alpha(00000868)=0.000000000000000E+00 beta (00000869)=0.130888456253258E+02 gamma(00000869)=0.130888456253258E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.32597E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 869 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000869)=0.000000000000000E+00 beta (00000870)=0.134428590019590E+02 gamma(00000870)=0.134428590019590E+02 lr_calc_dens: Charge drift due to real space implementation = 0.14752E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 870 z1= 1 0.474947183358331E-02 0.000000000000000E+00 z1= 2 -.655306473667438E-04 0.000000000000000E+00 z1= 3 0.152729488701738E-04 0.000000000000000E+00 alpha(00000870)=0.000000000000000E+00 beta (00000871)=0.130390351764038E+02 gamma(00000871)=0.130390351764038E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.27005E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 871 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000871)=0.000000000000000E+00 beta (00000872)=0.134709001881815E+02 gamma(00000872)=0.134709001881815E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10132E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 872 z1= 1 -.488356069605818E-02 0.000000000000000E+00 z1= 2 0.681165772941457E-04 0.000000000000000E+00 z1= 3 -.411103214254113E-05 0.000000000000000E+00 alpha(00000872)=0.000000000000000E+00 beta (00000873)=0.131367272985755E+02 gamma(00000873)=0.131367272985755E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.22123E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 873 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000873)=0.000000000000000E+00 beta (00000874)=0.134659280778054E+02 gamma(00000874)=0.134659280778054E+02 lr_calc_dens: Charge drift due to real space implementation = 0.88378E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 874 z1= 1 0.505224958081180E-02 0.000000000000000E+00 z1= 2 -.726196128577892E-04 0.000000000000000E+00 z1= 3 -.746008192264816E-05 0.000000000000000E+00 alpha(00000874)=0.000000000000000E+00 beta (00000875)=0.130279093490611E+02 gamma(00000875)=0.130279093490611E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.19162E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 875 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000875)=0.000000000000000E+00 beta (00000876)=0.135074923679166E+02 gamma(00000876)=0.135074923679166E+02 lr_calc_dens: Charge drift due to real space implementation = -0.93514E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 876 z1= 1 -.517567870463525E-02 0.000000000000000E+00 z1= 2 0.768295424772259E-04 0.000000000000000E+00 z1= 3 0.191456714124245E-04 0.000000000000000E+00 alpha(00000876)=0.000000000000000E+00 beta (00000877)=0.130381580106225E+02 gamma(00000877)=0.130381580106225E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.18550E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 877 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000877)=0.000000000000000E+00 beta (00000878)=0.134754032331652E+02 gamma(00000878)=0.134754032331652E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11652E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 878 z1= 1 0.521886547523852E-02 0.000000000000000E+00 z1= 2 -.798476328664859E-04 0.000000000000000E+00 z1= 3 -.312087620263393E-04 0.000000000000000E+00 alpha(00000878)=0.000000000000000E+00 beta (00000879)=0.131031510044223E+02 gamma(00000879)=0.131031510044223E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.20121E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 879 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000879)=0.000000000000000E+00 beta (00000880)=0.134303195099567E+02 gamma(00000880)=0.134303195099567E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11645E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 880 z1= 1 -.524725168223280E-02 0.000000000000000E+00 z1= 2 0.807009764793179E-04 0.000000000000000E+00 z1= 3 0.440778597243088E-04 0.000000000000000E+00 alpha(00000880)=0.000000000000000E+00 beta (00000881)=0.130787619999340E+02 gamma(00000881)=0.130787619999340E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.20679E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 881 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000881)=0.000000000000000E+00 beta (00000882)=0.134395343197964E+02 gamma(00000882)=0.134395343197964E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11513E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 882 z1= 1 0.518577153783356E-02 0.000000000000000E+00 z1= 2 -.827502474484744E-04 0.000000000000000E+00 z1= 3 -.571348316859163E-04 0.000000000000000E+00 alpha(00000882)=0.000000000000000E+00 beta (00000883)=0.131000235156044E+02 gamma(00000883)=0.131000235156044E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.20996E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 883 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000883)=0.000000000000000E+00 beta (00000884)=0.134712513244006E+02 gamma(00000884)=0.134712513244006E+02 lr_calc_dens: Charge drift due to real space implementation = -0.13755E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 884 z1= 1 -.493179567425200E-02 0.000000000000000E+00 z1= 2 0.833862588964455E-04 0.000000000000000E+00 z1= 3 0.699631413533356E-04 0.000000000000000E+00 alpha(00000884)=0.000000000000000E+00 beta (00000885)=0.130420567935821E+02 gamma(00000885)=0.130420567935821E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.22357E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 885 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000885)=0.000000000000000E+00 beta (00000886)=0.134808831579710E+02 gamma(00000886)=0.134808831579710E+02 lr_calc_dens: Charge drift due to real space implementation = 0.18471E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 886 z1= 1 0.449375733221509E-02 0.000000000000000E+00 z1= 2 -.833491724357982E-04 0.000000000000000E+00 z1= 3 -.826850155221381E-04 0.000000000000000E+00 alpha(00000886)=0.000000000000000E+00 beta (00000887)=0.130811152079013E+02 gamma(00000887)=0.130811152079013E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.28718E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 887 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000887)=0.000000000000000E+00 beta (00000888)=0.134736796682248E+02 gamma(00000888)=0.134736796682248E+02 lr_calc_dens: Charge drift due to real space implementation = -0.16201E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 888 z1= 1 -.404472562651038E-02 0.000000000000000E+00 z1= 2 0.851620614632249E-04 0.000000000000000E+00 z1= 3 0.957239622637202E-04 0.000000000000000E+00 alpha(00000888)=0.000000000000000E+00 beta (00000889)=0.130399476765732E+02 gamma(00000889)=0.130399476765732E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.27997E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 889 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000889)=0.000000000000000E+00 beta (00000890)=0.135172437583968E+02 gamma(00000890)=0.135172437583968E+02 lr_calc_dens: Charge drift due to real space implementation = 0.21368E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 890 z1= 1 0.359668915074107E-02 0.000000000000000E+00 z1= 2 -.855497017637173E-04 0.000000000000000E+00 z1= 3 -.108364998437509E-03 0.000000000000000E+00 alpha(00000890)=0.000000000000000E+00 beta (00000891)=0.130491454836625E+02 gamma(00000891)=0.130491454836625E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.37134E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 891 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000891)=0.000000000000000E+00 beta (00000892)=0.134137637982409E+02 gamma(00000892)=0.134137637982409E+02 lr_calc_dens: Charge drift due to real space implementation = -0.18720E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 892 z1= 1 -.320422129142389E-02 0.000000000000000E+00 z1= 2 0.860762430256370E-04 0.000000000000000E+00 z1= 3 0.121960077090139E-03 0.000000000000000E+00 alpha(00000892)=0.000000000000000E+00 beta (00000893)=0.130330146204901E+02 gamma(00000893)=0.130330146204901E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.47243E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 893 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000893)=0.000000000000000E+00 beta (00000894)=0.135061171240250E+02 gamma(00000894)=0.135061171240250E+02 lr_calc_dens: Charge drift due to real space implementation = 0.52256E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 894 z1= 1 0.294090148183026E-02 0.000000000000000E+00 z1= 2 -.849896971224316E-04 0.000000000000000E+00 z1= 3 -.133969274851830E-03 0.000000000000000E+00 alpha(00000894)=0.000000000000000E+00 beta (00000895)=0.129768363884514E+02 gamma(00000895)=0.129768363884514E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.43738E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 895 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000895)=0.000000000000000E+00 beta (00000896)=0.135137608560415E+02 gamma(00000896)=0.135137608560415E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12169E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 896 z1= 1 -.273457616577968E-02 0.000000000000000E+00 z1= 2 0.854768384910727E-04 0.000000000000000E+00 z1= 3 0.144366092104773E-03 0.000000000000000E+00 alpha(00000896)=0.000000000000000E+00 beta (00000897)=0.130268047506505E+02 gamma(00000897)=0.130268047506505E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.41456E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 897 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000897)=0.000000000000000E+00 beta (00000898)=0.135229850312521E+02 gamma(00000898)=0.135229850312521E+02 lr_calc_dens: Charge drift due to real space implementation = 0.76597E-10 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 898 z1= 1 0.256771796068204E-02 0.000000000000000E+00 z1= 2 -.874031213760618E-04 0.000000000000000E+00 z1= 3 -.154583746288817E-03 0.000000000000000E+00 alpha(00000898)=0.000000000000000E+00 beta (00000899)=0.130507303501837E+02 gamma(00000899)=0.130507303501837E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.45151E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 899 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000899)=0.000000000000000E+00 beta (00000900)=0.135293104322768E+02 gamma(00000900)=0.135293104322768E+02 lr_calc_dens: Charge drift due to real space implementation = 0.73956E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 900 z1= 1 -.252269925132742E-02 0.000000000000000E+00 z1= 2 0.882322921760183E-04 0.000000000000000E+00 z1= 3 0.164428060674496E-03 0.000000000000000E+00 alpha(00000900)=0.000000000000000E+00 beta (00000901)=0.130160653880122E+02 gamma(00000901)=0.130160653880122E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.36919E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 901 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000901)=0.000000000000000E+00 beta (00000902)=0.134778884569452E+02 gamma(00000902)=0.134778884569452E+02 lr_calc_dens: Charge drift due to real space implementation = -0.15425E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 902 z1= 1 0.266140689184145E-02 0.000000000000000E+00 z1= 2 -.891310907649989E-04 0.000000000000000E+00 z1= 3 -.174127808117259E-03 0.000000000000000E+00 alpha(00000902)=0.000000000000000E+00 beta (00000903)=0.130822002493458E+02 gamma(00000903)=0.130822002493458E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.36076E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 903 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000903)=0.000000000000000E+00 beta (00000904)=0.135088676061667E+02 gamma(00000904)=0.135088676061667E+02 lr_calc_dens: Charge drift due to real space implementation = -0.40404E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 904 z1= 1 -.295150107645452E-02 0.000000000000000E+00 z1= 2 0.899269967207170E-04 0.000000000000000E+00 z1= 3 0.184213128645280E-03 0.000000000000000E+00 alpha(00000904)=0.000000000000000E+00 beta (00000905)=0.130999987321071E+02 gamma(00000905)=0.130999987321071E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.38445E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 905 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000905)=0.000000000000000E+00 beta (00000906)=0.134797733567009E+02 gamma(00000906)=0.134797733567009E+02 lr_calc_dens: Charge drift due to real space implementation = 0.64150E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 906 z1= 1 0.326333547877934E-02 0.000000000000000E+00 z1= 2 -.937980012344526E-04 0.000000000000000E+00 z1= 3 -.195151270043574E-03 0.000000000000000E+00 alpha(00000906)=0.000000000000000E+00 beta (00000907)=0.129413531028542E+02 gamma(00000907)=0.129413531028542E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.39277E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 907 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000907)=0.000000000000000E+00 beta (00000908)=0.135180208087627E+02 gamma(00000908)=0.135180208087627E+02 lr_calc_dens: Charge drift due to real space implementation = -0.13831E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 908 z1= 1 -.349494350414331E-02 0.000000000000000E+00 z1= 2 0.969340747711649E-04 0.000000000000000E+00 z1= 3 0.203125280065960E-03 0.000000000000000E+00 alpha(00000908)=0.000000000000000E+00 beta (00000909)=0.130078518095692E+02 gamma(00000909)=0.130078518095692E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.52674E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 909 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000909)=0.000000000000000E+00 beta (00000910)=0.135967598070571E+02 gamma(00000910)=0.135967598070571E+02 lr_calc_dens: Charge drift due to real space implementation = 0.74395E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 910 z1= 1 0.377644661297563E-02 0.000000000000000E+00 z1= 2 -.966678568411015E-04 0.000000000000000E+00 z1= 3 -.210632533921015E-03 0.000000000000000E+00 alpha(00000910)=0.000000000000000E+00 beta (00000911)=0.130230320536844E+02 gamma(00000911)=0.130230320536844E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.58632E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 911 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000911)=0.000000000000000E+00 beta (00000912)=0.135062463100612E+02 gamma(00000912)=0.135062463100612E+02 lr_calc_dens: Charge drift due to real space implementation = -0.24551E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 912 z1= 1 -.413083671539350E-02 0.000000000000000E+00 z1= 2 0.974789918987678E-04 0.000000000000000E+00 z1= 3 0.220147191647669E-03 0.000000000000000E+00 alpha(00000912)=0.000000000000000E+00 beta (00000913)=0.130072238714152E+02 gamma(00000913)=0.130072238714152E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.65810E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 913 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000913)=0.000000000000000E+00 beta (00000914)=0.135018510669983E+02 gamma(00000914)=0.135018510669983E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10593E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 914 z1= 1 0.453381009054495E-02 0.000000000000000E+00 z1= 2 -.979913857241128E-04 0.000000000000000E+00 z1= 3 -.229465682681129E-03 0.000000000000000E+00 alpha(00000914)=0.000000000000000E+00 beta (00000915)=0.130531226397000E+02 gamma(00000915)=0.130531226397000E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.60045E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 915 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000915)=0.000000000000000E+00 beta (00000916)=0.134686482851587E+02 gamma(00000916)=0.134686482851587E+02 lr_calc_dens: Charge drift due to real space implementation = 0.14039E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 916 z1= 1 -.508654265452635E-02 0.000000000000000E+00 z1= 2 0.993835924722412E-04 0.000000000000000E+00 z1= 3 0.240117716390009E-03 0.000000000000000E+00 alpha(00000916)=0.000000000000000E+00 beta (00000917)=0.130490200284838E+02 gamma(00000917)=0.130490200284838E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.55659E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 917 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000917)=0.000000000000000E+00 beta (00000918)=0.134869761516191E+02 gamma(00000918)=0.134869761516191E+02 lr_calc_dens: Charge drift due to real space implementation = -0.15442E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 918 z1= 1 0.568923046089042E-02 0.000000000000000E+00 z1= 2 -.102650344633089E-03 0.000000000000000E+00 z1= 3 -.250558689535502E-03 0.000000000000000E+00 alpha(00000918)=0.000000000000000E+00 beta (00000919)=0.131543054805568E+02 gamma(00000919)=0.131543054805568E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.47916E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 919 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000919)=0.000000000000000E+00 beta (00000920)=0.134292001753357E+02 gamma(00000920)=0.134292001753357E+02 lr_calc_dens: Charge drift due to real space implementation = 0.95335E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 920 z1= 1 -.627805651431513E-02 0.000000000000000E+00 z1= 2 0.108149472051271E-03 0.000000000000000E+00 z1= 3 0.263537483106464E-03 0.000000000000000E+00 alpha(00000920)=0.000000000000000E+00 beta (00000921)=0.130168078794194E+02 gamma(00000921)=0.130168078794194E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.44591E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 921 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000921)=0.000000000000000E+00 beta (00000922)=0.134486711748011E+02 gamma(00000922)=0.134486711748011E+02 lr_calc_dens: Charge drift due to real space implementation = 0.93272E-10 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 922 z1= 1 0.665833466215697E-02 0.000000000000000E+00 z1= 2 -.112084457857065E-03 0.000000000000000E+00 z1= 3 -.272661860777753E-03 0.000000000000000E+00 alpha(00000922)=0.000000000000000E+00 beta (00000923)=0.129936916638339E+02 gamma(00000923)=0.129936916638339E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.49176E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 923 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000923)=0.000000000000000E+00 beta (00000924)=0.134941926490850E+02 gamma(00000924)=0.134941926490850E+02 lr_calc_dens: Charge drift due to real space implementation = -0.93591E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 924 z1= 1 -.692643134776218E-02 0.000000000000000E+00 z1= 2 0.115956606416476E-03 0.000000000000000E+00 z1= 3 0.279701472952622E-03 0.000000000000000E+00 alpha(00000924)=0.000000000000000E+00 beta (00000925)=0.130928663584497E+02 gamma(00000925)=0.130928663584497E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.62766E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 925 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000925)=0.000000000000000E+00 beta (00000926)=0.134936797832749E+02 gamma(00000926)=0.134936797832749E+02 lr_calc_dens: Charge drift due to real space implementation = 0.67573E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 926 z1= 1 0.721585260073702E-02 0.000000000000000E+00 z1= 2 -.120123094700678E-03 0.000000000000000E+00 z1= 3 -.288091046817242E-03 0.000000000000000E+00 alpha(00000926)=0.000000000000000E+00 beta (00000927)=0.129391529431627E+02 gamma(00000927)=0.129391529431627E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.76632E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 927 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000927)=0.000000000000000E+00 beta (00000928)=0.134611620919612E+02 gamma(00000928)=0.134611620919612E+02 lr_calc_dens: Charge drift due to real space implementation = 0.69979E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 928 z1= 1 -.738772310830337E-02 0.000000000000000E+00 z1= 2 0.122416510237672E-03 0.000000000000000E+00 z1= 3 0.294317514571858E-03 0.000000000000000E+00 alpha(00000928)=0.000000000000000E+00 beta (00000929)=0.130413581629527E+02 gamma(00000929)=0.130413581629527E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.72042E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 929 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000929)=0.000000000000000E+00 beta (00000930)=0.134793389750286E+02 gamma(00000930)=0.134793389750286E+02 lr_calc_dens: Charge drift due to real space implementation = -0.28820E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 930 z1= 1 0.755516146101882E-02 0.000000000000000E+00 z1= 2 -.125723456586662E-03 0.000000000000000E+00 z1= 3 -.302412976227481E-03 0.000000000000000E+00 alpha(00000930)=0.000000000000000E+00 beta (00000931)=0.131101577415134E+02 gamma(00000931)=0.131101577415134E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.82241E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 931 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000931)=0.000000000000000E+00 beta (00000932)=0.135082620316846E+02 gamma(00000932)=0.135082620316846E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10155E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 932 z1= 1 -.775238854469191E-02 0.000000000000000E+00 z1= 2 0.129052967082720E-03 0.000000000000000E+00 z1= 3 0.311387434055839E-03 0.000000000000000E+00 alpha(00000932)=0.000000000000000E+00 beta (00000933)=0.130165700390465E+02 gamma(00000933)=0.130165700390465E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.88253E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 933 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000933)=0.000000000000000E+00 beta (00000934)=0.134684435515716E+02 gamma(00000934)=0.134684435515716E+02 lr_calc_dens: Charge drift due to real space implementation = -0.23443E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 934 z1= 1 0.789482914070603E-02 0.000000000000000E+00 z1= 2 -.133430194538240E-03 0.000000000000000E+00 z1= 3 -.319991916792122E-03 0.000000000000000E+00 alpha(00000934)=0.000000000000000E+00 beta (00000935)=0.130407719162461E+02 gamma(00000935)=0.130407719162461E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.80534E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 935 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000935)=0.000000000000000E+00 beta (00000936)=0.135515708968566E+02 gamma(00000936)=0.135515708968566E+02 lr_calc_dens: Charge drift due to real space implementation = 0.27663E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 936 z1= 1 -.799812298570211E-02 0.000000000000000E+00 z1= 2 0.137953271136221E-03 0.000000000000000E+00 z1= 3 0.328199733818222E-03 0.000000000000000E+00 alpha(00000936)=0.000000000000000E+00 beta (00000937)=0.129736556805890E+02 gamma(00000937)=0.129736556805890E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.70891E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 937 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000937)=0.000000000000000E+00 beta (00000938)=0.135674885893612E+02 gamma(00000938)=0.135674885893612E+02 lr_calc_dens: Charge drift due to real space implementation = -0.21470E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 938 z1= 1 0.806919615843856E-02 0.000000000000000E+00 z1= 2 -.138790221132268E-03 0.000000000000000E+00 z1= 3 -.335725580680800E-03 0.000000000000000E+00 alpha(00000938)=0.000000000000000E+00 beta (00000939)=0.130046562889805E+02 gamma(00000939)=0.130046562889805E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.66603E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 939 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000939)=0.000000000000000E+00 beta (00000940)=0.135248061502168E+02 gamma(00000940)=0.135248061502168E+02 lr_calc_dens: Charge drift due to real space implementation = 0.74480E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 940 z1= 1 -.817096904849142E-02 0.000000000000000E+00 z1= 2 0.140493353379546E-03 0.000000000000000E+00 z1= 3 0.346455191026920E-03 0.000000000000000E+00 alpha(00000940)=0.000000000000000E+00 beta (00000941)=0.129582859000464E+02 gamma(00000941)=0.129582859000464E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.78890E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 941 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000941)=0.000000000000000E+00 beta (00000942)=0.135214067169884E+02 gamma(00000942)=0.135214067169884E+02 lr_calc_dens: Charge drift due to real space implementation = -0.61665E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 942 z1= 1 0.824425086438433E-02 0.000000000000000E+00 z1= 2 -.145160009345290E-03 0.000000000000000E+00 z1= 3 -.357196449175940E-03 0.000000000000000E+00 alpha(00000942)=0.000000000000000E+00 beta (00000943)=0.129348805137637E+02 gamma(00000943)=0.129348805137637E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.92668E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 943 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000943)=0.000000000000000E+00 beta (00000944)=0.134801687785725E+02 gamma(00000944)=0.134801687785725E+02 lr_calc_dens: Charge drift due to real space implementation = 0.19138E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 944 z1= 1 -.828783923262148E-02 0.000000000000000E+00 z1= 2 0.147999549959527E-03 0.000000000000000E+00 z1= 3 0.369033614985076E-03 0.000000000000000E+00 alpha(00000944)=0.000000000000000E+00 beta (00000945)=0.129931798820064E+02 gamma(00000945)=0.129931798820064E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.88255E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 945 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000945)=0.000000000000000E+00 beta (00000946)=0.135706517754273E+02 gamma(00000946)=0.135706517754273E+02 lr_calc_dens: Charge drift due to real space implementation = -0.19398E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 946 z1= 1 0.818463939297992E-02 0.000000000000000E+00 z1= 2 -.149848618188956E-03 0.000000000000000E+00 z1= 3 -.379550162443169E-03 0.000000000000000E+00 alpha(00000946)=0.000000000000000E+00 beta (00000947)=0.130164836150846E+02 gamma(00000947)=0.130164836150846E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.89692E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 947 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000947)=0.000000000000000E+00 beta (00000948)=0.134765023762182E+02 gamma(00000948)=0.134765023762182E+02 lr_calc_dens: Charge drift due to real space implementation = 0.21575E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 948 z1= 1 -.806717483309815E-02 0.000000000000000E+00 z1= 2 0.156681445846577E-03 0.000000000000000E+00 z1= 3 0.393390437400447E-03 0.000000000000000E+00 alpha(00000948)=0.000000000000000E+00 beta (00000949)=0.129776743357386E+02 gamma(00000949)=0.129776743357386E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.88223E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 949 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000949)=0.000000000000000E+00 beta (00000950)=0.134289929556563E+02 gamma(00000950)=0.134289929556563E+02 lr_calc_dens: Charge drift due to real space implementation = -0.17417E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 950 z1= 1 0.787696669001745E-02 0.000000000000000E+00 z1= 2 -.161600847012029E-03 0.000000000000000E+00 z1= 3 -.407372380739376E-03 0.000000000000000E+00 alpha(00000950)=0.000000000000000E+00 beta (00000951)=0.130188741247894E+02 gamma(00000951)=0.130188741247894E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.97153E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 951 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000951)=0.000000000000000E+00 beta (00000952)=0.135320237554047E+02 gamma(00000952)=0.135320237554047E+02 lr_calc_dens: Charge drift due to real space implementation = 0.23981E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 952 z1= 1 -.764523583364929E-02 0.000000000000000E+00 z1= 2 0.163930082019908E-03 0.000000000000000E+00 z1= 3 0.418986458788028E-03 0.000000000000000E+00 alpha(00000952)=0.000000000000000E+00 beta (00000953)=0.129715015329623E+02 gamma(00000953)=0.129715015329623E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10186E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 953 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000953)=0.000000000000000E+00 beta (00000954)=0.134719733863910E+02 gamma(00000954)=0.134719733863910E+02 lr_calc_dens: Charge drift due to real space implementation = -0.34843E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 954 z1= 1 0.741389431343562E-02 0.000000000000000E+00 z1= 2 -.167219329767031E-03 0.000000000000000E+00 z1= 3 -.430704834289008E-03 0.000000000000000E+00 alpha(00000954)=0.000000000000000E+00 beta (00000955)=0.129448280749356E+02 gamma(00000955)=0.129448280749356E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.91256E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 955 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000955)=0.000000000000000E+00 beta (00000956)=0.134871546821003E+02 gamma(00000956)=0.134871546821003E+02 lr_calc_dens: Charge drift due to real space implementation = 0.26137E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 956 z1= 1 -.707580455021009E-02 0.000000000000000E+00 z1= 2 0.170509930782345E-03 0.000000000000000E+00 z1= 3 0.441251670341219E-03 0.000000000000000E+00 alpha(00000956)=0.000000000000000E+00 beta (00000957)=0.130107279917903E+02 gamma(00000957)=0.130107279917903E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.91392E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 957 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000957)=0.000000000000000E+00 beta (00000958)=0.134498007842896E+02 gamma(00000958)=0.134498007842896E+02 lr_calc_dens: Charge drift due to real space implementation = -0.15639E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 958 z1= 1 0.671664634224090E-02 0.000000000000000E+00 z1= 2 -.173763533301708E-03 0.000000000000000E+00 z1= 3 -.454522187016334E-03 0.000000000000000E+00 alpha(00000958)=0.000000000000000E+00 beta (00000959)=0.129627505134207E+02 gamma(00000959)=0.129627505134207E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10420E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 959 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000959)=0.000000000000000E+00 beta (00000960)=0.135283651212994E+02 gamma(00000960)=0.135283651212994E+02 lr_calc_dens: Charge drift due to real space implementation = 0.16581E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 960 z1= 1 -.630639391996930E-02 0.000000000000000E+00 z1= 2 0.176928536023047E-03 0.000000000000000E+00 z1= 3 0.462397605303023E-03 0.000000000000000E+00 alpha(00000960)=0.000000000000000E+00 beta (00000961)=0.129586883873742E+02 gamma(00000961)=0.129586883873742E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11815E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 961 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000961)=0.000000000000000E+00 beta (00000962)=0.135615360097830E+02 gamma(00000962)=0.135615360097830E+02 lr_calc_dens: Charge drift due to real space implementation = -0.29806E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 962 z1= 1 0.591572657401021E-02 0.000000000000000E+00 z1= 2 -.177130486108321E-03 0.000000000000000E+00 z1= 3 -.468297381991521E-03 0.000000000000000E+00 alpha(00000962)=0.000000000000000E+00 beta (00000963)=0.129565705873602E+02 gamma(00000963)=0.129565705873602E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.11734E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 963 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000963)=0.000000000000000E+00 beta (00000964)=0.135568345311272E+02 gamma(00000964)=0.135568345311272E+02 lr_calc_dens: Charge drift due to real space implementation = 0.35841E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 964 z1= 1 -.550507548763970E-02 0.000000000000000E+00 z1= 2 0.177069101654182E-03 0.000000000000000E+00 z1= 3 0.474656913004881E-03 0.000000000000000E+00 alpha(00000964)=0.000000000000000E+00 beta (00000965)=0.129990985125439E+02 gamma(00000965)=0.129990985125439E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11174E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 965 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000965)=0.000000000000000E+00 beta (00000966)=0.134827663450875E+02 gamma(00000966)=0.134827663450875E+02 lr_calc_dens: Charge drift due to real space implementation = -0.33593E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 966 z1= 1 0.515739736817204E-02 0.000000000000000E+00 z1= 2 -.178598521931424E-03 0.000000000000000E+00 z1= 3 -.485184481203209E-03 0.000000000000000E+00 alpha(00000966)=0.000000000000000E+00 beta (00000967)=0.129750609562476E+02 gamma(00000967)=0.129750609562476E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10783E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 967 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000967)=0.000000000000000E+00 beta (00000968)=0.135373556645337E+02 gamma(00000968)=0.135373556645337E+02 lr_calc_dens: Charge drift due to real space implementation = 0.22973E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 968 z1= 1 -.484357179863455E-02 0.000000000000000E+00 z1= 2 0.179558450105776E-03 0.000000000000000E+00 z1= 3 0.493536871409875E-03 0.000000000000000E+00 alpha(00000968)=0.000000000000000E+00 beta (00000969)=0.129542899067293E+02 gamma(00000969)=0.129542899067293E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11715E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 969 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000969)=0.000000000000000E+00 beta (00000970)=0.135230166434618E+02 gamma(00000970)=0.135230166434618E+02 lr_calc_dens: Charge drift due to real space implementation = -0.17250E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 970 z1= 1 0.461591339662627E-02 0.000000000000000E+00 z1= 2 -.183513202933648E-03 0.000000000000000E+00 z1= 3 -.501300277362993E-03 0.000000000000000E+00 alpha(00000970)=0.000000000000000E+00 beta (00000971)=0.130393928812508E+02 gamma(00000971)=0.130393928812508E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13793E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 971 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000971)=0.000000000000000E+00 beta (00000972)=0.135946134440079E+02 gamma(00000972)=0.135946134440079E+02 lr_calc_dens: Charge drift due to real space implementation = 0.36519E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 972 z1= 1 -.447734474098535E-02 0.000000000000000E+00 z1= 2 0.188238705094503E-03 0.000000000000000E+00 z1= 3 0.509974863177647E-03 0.000000000000000E+00 alpha(00000972)=0.000000000000000E+00 beta (00000973)=0.129553771495882E+02 gamma(00000973)=0.129553771495882E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.13898E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 973 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000973)=0.000000000000000E+00 beta (00000974)=0.136385182348487E+02 gamma(00000974)=0.136385182348487E+02 lr_calc_dens: Charge drift due to real space implementation = -0.47277E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 974 z1= 1 0.429764573439208E-02 0.000000000000000E+00 z1= 2 -.187028920102389E-03 0.000000000000000E+00 z1= 3 -.513401380919516E-03 0.000000000000000E+00 alpha(00000974)=0.000000000000000E+00 beta (00000975)=0.130037344155453E+02 gamma(00000975)=0.130037344155453E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13391E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 975 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000975)=0.000000000000000E+00 beta (00000976)=0.135940193043635E+02 gamma(00000976)=0.135940193043635E+02 lr_calc_dens: Charge drift due to real space implementation = 0.48931E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 976 z1= 1 -.418790699181147E-02 0.000000000000000E+00 z1= 2 0.185917999695987E-03 0.000000000000000E+00 z1= 3 0.520596531197372E-03 0.000000000000000E+00 alpha(00000976)=0.000000000000000E+00 beta (00000977)=0.130200846441703E+02 gamma(00000977)=0.130200846441703E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.13211E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 977 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000977)=0.000000000000000E+00 beta (00000978)=0.135466453259344E+02 gamma(00000978)=0.135466453259344E+02 lr_calc_dens: Charge drift due to real space implementation = -0.52188E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 978 z1= 1 0.422731938066938E-02 0.000000000000000E+00 z1= 2 -.190922264721576E-03 0.000000000000000E+00 z1= 3 -.529780696048089E-03 0.000000000000000E+00 alpha(00000978)=0.000000000000000E+00 beta (00000979)=0.128631941866171E+02 gamma(00000979)=0.128631941866171E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12595E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 979 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000979)=0.000000000000000E+00 beta (00000980)=0.135569073205525E+02 gamma(00000980)=0.135569073205525E+02 lr_calc_dens: Charge drift due to real space implementation = 0.46797E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 980 z1= 1 -.432959849039729E-02 0.000000000000000E+00 z1= 2 0.194304567127270E-03 0.000000000000000E+00 z1= 3 0.533388934746639E-03 0.000000000000000E+00 alpha(00000980)=0.000000000000000E+00 beta (00000981)=0.129893881887150E+02 gamma(00000981)=0.129893881887150E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11833E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 981 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000981)=0.000000000000000E+00 beta (00000982)=0.135933989128223E+02 gamma(00000982)=0.135933989128223E+02 lr_calc_dens: Charge drift due to real space implementation = -0.29140E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 982 z1= 1 0.440655866096312E-02 0.000000000000000E+00 z1= 2 -.195501919537403E-03 0.000000000000000E+00 z1= 3 -.540349438139356E-03 0.000000000000000E+00 alpha(00000982)=0.000000000000000E+00 beta (00000983)=0.130400878354042E+02 gamma(00000983)=0.130400878354042E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12702E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 983 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000983)=0.000000000000000E+00 beta (00000984)=0.135257063857267E+02 gamma(00000984)=0.135257063857267E+02 lr_calc_dens: Charge drift due to real space implementation = 0.18496E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 984 z1= 1 -.441143656373309E-02 0.000000000000000E+00 z1= 2 0.199306009202069E-03 0.000000000000000E+00 z1= 3 0.552574126262184E-03 0.000000000000000E+00 alpha(00000984)=0.000000000000000E+00 beta (00000985)=0.130290489185924E+02 gamma(00000985)=0.130290489185924E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.14385E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 985 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000985)=0.000000000000000E+00 beta (00000986)=0.135162215072629E+02 gamma(00000986)=0.135162215072629E+02 lr_calc_dens: Charge drift due to real space implementation = -0.17854E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 986 z1= 1 0.436129601358402E-02 0.000000000000000E+00 z1= 2 -.200498436352819E-03 0.000000000000000E+00 z1= 3 -.564187177196820E-03 0.000000000000000E+00 alpha(00000986)=0.000000000000000E+00 beta (00000987)=0.130089133645962E+02 gamma(00000987)=0.130089133645962E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.16797E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 987 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000987)=0.000000000000000E+00 beta (00000988)=0.135663859422775E+02 gamma(00000988)=0.135663859422775E+02 lr_calc_dens: Charge drift due to real space implementation = 0.41443E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 988 z1= 1 -.428192008462141E-02 0.000000000000000E+00 z1= 2 0.202295105376631E-03 0.000000000000000E+00 z1= 3 0.573613588670589E-03 0.000000000000000E+00 alpha(00000988)=0.000000000000000E+00 beta (00000989)=0.128895354834455E+02 gamma(00000989)=0.128895354834455E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.17133E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 989 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000989)=0.000000000000000E+00 beta (00000990)=0.135433470219177E+02 gamma(00000990)=0.135433470219177E+02 lr_calc_dens: Charge drift due to real space implementation = -0.61373E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 990 z1= 1 0.424824525394876E-02 0.000000000000000E+00 z1= 2 -.204743883541984E-03 0.000000000000000E+00 z1= 3 -.580055211418589E-03 0.000000000000000E+00 alpha(00000990)=0.000000000000000E+00 beta (00000991)=0.129698078542945E+02 gamma(00000991)=0.129698078542945E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.15305E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 991 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000991)=0.000000000000000E+00 beta (00000992)=0.134951227680296E+02 gamma(00000992)=0.134951227680296E+02 lr_calc_dens: Charge drift due to real space implementation = 0.51212E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 992 z1= 1 -.430978522019065E-02 0.000000000000000E+00 z1= 2 0.205620273655050E-03 0.000000000000000E+00 z1= 3 0.593861009059300E-03 0.000000000000000E+00 alpha(00000992)=0.000000000000000E+00 beta (00000993)=0.130275818869357E+02 gamma(00000993)=0.130275818869357E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.15837E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 993 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000993)=0.000000000000000E+00 beta (00000994)=0.136146600866446E+02 gamma(00000994)=0.136146600866446E+02 lr_calc_dens: Charge drift due to real space implementation = -0.54973E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 994 z1= 1 0.434895899068229E-02 0.000000000000000E+00 z1= 2 -.205590595017711E-03 0.000000000000000E+00 z1= 3 -.605117975994029E-03 0.000000000000000E+00 alpha(00000994)=0.000000000000000E+00 beta (00000995)=0.128729949106782E+02 gamma(00000995)=0.128729949106782E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.15982E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 995 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000995)=0.000000000000000E+00 beta (00000996)=0.135004702427067E+02 gamma(00000996)=0.135004702427067E+02 lr_calc_dens: Charge drift due to real space implementation = 0.55248E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 996 z1= 1 -.431620877904414E-02 0.000000000000000E+00 z1= 2 0.209600870450799E-03 0.000000000000000E+00 z1= 3 0.616042697414376E-03 0.000000000000000E+00 alpha(00000996)=0.000000000000000E+00 beta (00000997)=0.129219379484442E+02 gamma(00000997)=0.129219379484442E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.15212E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 997 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000997)=0.000000000000000E+00 beta (00000998)=0.135837607102478E+02 gamma(00000998)=0.135837607102478E+02 lr_calc_dens: Charge drift due to real space implementation = -0.35932E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 998 z1= 1 0.407594093350613E-02 0.000000000000000E+00 z1= 2 -.211545356930028E-03 0.000000000000000E+00 z1= 3 -.625540812228504E-03 0.000000000000000E+00 alpha(00000998)=0.000000000000000E+00 beta (00000999)=0.129521320362514E+02 gamma(00000999)=0.129521320362514E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.16726E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 999 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000999)=0.000000000000000E+00 beta (00001000)=0.135961610666916E+02 gamma(00001000)=0.135961610666916E+02 lr_calc_dens: Charge drift due to real space implementation = 0.29941E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1000 z1= 1 -.374278895781171E-02 0.000000000000000E+00 z1= 2 0.211628295039928E-03 0.000000000000000E+00 z1= 3 0.636329211524166E-03 0.000000000000000E+00 alpha(00001000)=0.000000000000000E+00 beta (00001001)=0.129844650311503E+02 gamma(00001001)=0.129844650311503E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.18476E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1001 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001001)=0.000000000000000E+00 beta (00001002)=0.135169788760550E+02 gamma(00001002)=0.135169788760550E+02 lr_calc_dens: Charge drift due to real space implementation = -0.33915E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1002 z1= 1 0.340410974131464E-02 0.000000000000000E+00 z1= 2 -.214367457026911E-03 0.000000000000000E+00 z1= 3 -.652235863904874E-03 0.000000000000000E+00 alpha(00001002)=0.000000000000000E+00 beta (00001003)=0.129487042301092E+02 gamma(00001003)=0.129487042301092E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.20098E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1003 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001003)=0.000000000000000E+00 beta (00001004)=0.134868770519647E+02 gamma(00001004)=0.134868770519647E+02 lr_calc_dens: Charge drift due to real space implementation = 0.46336E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1004 z1= 1 -.300583811732489E-02 0.000000000000000E+00 z1= 2 0.216963042026192E-03 0.000000000000000E+00 z1= 3 0.668556011886589E-03 0.000000000000000E+00 alpha(00001004)=0.000000000000000E+00 beta (00001005)=0.129492063323150E+02 gamma(00001005)=0.129492063323150E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.20918E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1005 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001005)=0.000000000000000E+00 beta (00001006)=0.135239310343422E+02 gamma(00001006)=0.135239310343422E+02 lr_calc_dens: Charge drift due to real space implementation = -0.63941E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1006 z1= 1 0.249243048343632E-02 0.000000000000000E+00 z1= 2 -.219164034489726E-03 0.000000000000000E+00 z1= 3 -.683042260108112E-03 0.000000000000000E+00 alpha(00001006)=0.000000000000000E+00 beta (00001007)=0.128768934600317E+02 gamma(00001007)=0.128768934600317E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.19993E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1007 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001007)=0.000000000000000E+00 beta (00001008)=0.135373195914960E+02 gamma(00001008)=0.135373195914960E+02 lr_calc_dens: Charge drift due to real space implementation = 0.58815E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1008 z1= 1 -.184967552680495E-02 0.000000000000000E+00 z1= 2 0.221830167860927E-03 0.000000000000000E+00 z1= 3 0.693792163956920E-03 0.000000000000000E+00 alpha(00001008)=0.000000000000000E+00 beta (00001009)=0.129115566787217E+02 gamma(00001009)=0.129115566787217E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.20281E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1009 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001009)=0.000000000000000E+00 beta (00001010)=0.135926303434799E+02 gamma(00001010)=0.135926303434799E+02 lr_calc_dens: Charge drift due to real space implementation = -0.50721E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1010 z1= 1 0.123546802900504E-02 0.000000000000000E+00 z1= 2 -.222445573871041E-03 0.000000000000000E+00 z1= 3 -.703544942514766E-03 0.000000000000000E+00 alpha(00001010)=0.000000000000000E+00 beta (00001011)=0.129695197515992E+02 gamma(00001011)=0.129695197515992E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.21963E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1011 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001011)=0.000000000000000E+00 beta (00001012)=0.134677486328025E+02 gamma(00001012)=0.134677486328025E+02 lr_calc_dens: Charge drift due to real space implementation = 0.58039E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1012 z1= 1 -.607178618031334E-03 0.000000000000000E+00 z1= 2 0.226202322057929E-03 0.000000000000000E+00 z1= 3 0.723422257235380E-03 0.000000000000000E+00 alpha(00001012)=0.000000000000000E+00 beta (00001013)=0.128817719051183E+02 gamma(00001013)=0.128817719051183E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.22815E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1013 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001013)=0.000000000000000E+00 beta (00001014)=0.134959219223297E+02 gamma(00001014)=0.134959219223297E+02 lr_calc_dens: Charge drift due to real space implementation = -0.69831E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1014 z1= 1 -.946422940292808E-04 0.000000000000000E+00 z1= 2 -.230810637544198E-03 0.000000000000000E+00 z1= 3 -.737115915256869E-03 0.000000000000000E+00 alpha(00001014)=0.000000000000000E+00 beta (00001015)=0.129983310564329E+02 gamma(00001015)=0.129983310564329E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.21955E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1015 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001015)=0.000000000000000E+00 beta (00001016)=0.135079155071051E+02 gamma(00001016)=0.135079155071051E+02 lr_calc_dens: Charge drift due to real space implementation = 0.68260E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1016 z1= 1 0.785278208364788E-03 0.000000000000000E+00 z1= 2 0.237090150980346E-03 0.000000000000000E+00 z1= 3 0.757255749336434E-03 0.000000000000000E+00 alpha(00001016)=0.000000000000000E+00 beta (00001017)=0.128299195720838E+02 gamma(00001017)=0.128299195720838E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.21626E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1017 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001017)=0.000000000000000E+00 beta (00001018)=0.135713052501890E+02 gamma(00001018)=0.135713052501890E+02 lr_calc_dens: Charge drift due to real space implementation = -0.55893E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1018 z1= 1 -.146126314324908E-02 0.000000000000000E+00 z1= 2 -.237635520951985E-03 0.000000000000000E+00 z1= 3 -.764598544409007E-03 0.000000000000000E+00 alpha(00001018)=0.000000000000000E+00 beta (00001019)=0.129536072675313E+02 gamma(00001019)=0.129536072675313E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.22435E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1019 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001019)=0.000000000000000E+00 beta (00001020)=0.136659467737655E+02 gamma(00001020)=0.136659467737655E+02 lr_calc_dens: Charge drift due to real space implementation = 0.43178E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1020 z1= 1 0.209722868301864E-02 0.000000000000000E+00 z1= 2 0.239991701029029E-03 0.000000000000000E+00 z1= 3 0.775019255854245E-03 0.000000000000000E+00 alpha(00001020)=0.000000000000000E+00 beta (00001021)=0.129979680506351E+02 gamma(00001021)=0.129979680506351E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.25050E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1021 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001021)=0.000000000000000E+00 beta (00001022)=0.135518112726619E+02 gamma(00001022)=0.135518112726619E+02 lr_calc_dens: Charge drift due to real space implementation = -0.51245E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1022 z1= 1 -.265503314786585E-02 0.000000000000000E+00 z1= 2 -.246898305685454E-03 0.000000000000000E+00 z1= 3 -.794829731483100E-03 0.000000000000000E+00 alpha(00001022)=0.000000000000000E+00 beta (00001023)=0.129853171298834E+02 gamma(00001023)=0.129853171298834E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.26790E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1023 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001023)=0.000000000000000E+00 beta (00001024)=0.134870787906347E+02 gamma(00001024)=0.134870787906347E+02 lr_calc_dens: Charge drift due to real space implementation = 0.65650E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1024 z1= 1 0.316711496389810E-02 0.000000000000000E+00 z1= 2 0.255287677642535E-03 0.000000000000000E+00 z1= 3 0.818768717591324E-03 0.000000000000000E+00 alpha(00001024)=0.000000000000000E+00 beta (00001025)=0.128764202904245E+02 gamma(00001025)=0.128764202904245E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.27519E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1025 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001025)=0.000000000000000E+00 beta (00001026)=0.136277781725321E+02 gamma(00001026)=0.136277781725321E+02 lr_calc_dens: Charge drift due to real space implementation = -0.71443E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1026 z1= 1 -.344299559094002E-02 0.000000000000000E+00 z1= 2 -.256643164685516E-03 0.000000000000000E+00 z1= 3 -.827226068744177E-03 0.000000000000000E+00 alpha(00001026)=0.000000000000000E+00 beta (00001027)=0.129986977076096E+02 gamma(00001027)=0.129986977076096E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.27781E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1027 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001027)=0.000000000000000E+00 beta (00001028)=0.135820118582662E+02 gamma(00001028)=0.135820118582662E+02 lr_calc_dens: Charge drift due to real space implementation = 0.65563E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1028 z1= 1 0.357790768656169E-02 0.000000000000000E+00 z1= 2 0.261425768412920E-03 0.000000000000000E+00 z1= 3 0.847760362468579E-03 0.000000000000000E+00 alpha(00001028)=0.000000000000000E+00 beta (00001029)=0.129948870203762E+02 gamma(00001029)=0.129948870203762E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.28853E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1029 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001029)=0.000000000000000E+00 beta (00001030)=0.135282408490858E+02 gamma(00001030)=0.135282408490858E+02 lr_calc_dens: Charge drift due to real space implementation = -0.60625E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1030 z1= 1 -.361975875227342E-02 0.000000000000000E+00 z1= 2 -.266743170216011E-03 0.000000000000000E+00 z1= 3 -.871751152886416E-03 0.000000000000000E+00 alpha(00001030)=0.000000000000000E+00 beta (00001031)=0.129188538342359E+02 gamma(00001031)=0.129188538342359E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.30881E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1031 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001031)=0.000000000000000E+00 beta (00001032)=0.135507749482515E+02 gamma(00001032)=0.135507749482515E+02 lr_calc_dens: Charge drift due to real space implementation = 0.66964E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1032 z1= 1 0.353486528897055E-02 0.000000000000000E+00 z1= 2 0.273583765533923E-03 0.000000000000000E+00 z1= 3 0.891516795074670E-03 0.000000000000000E+00 alpha(00001032)=0.000000000000000E+00 beta (00001033)=0.130351559608376E+02 gamma(00001033)=0.130351559608376E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.32362E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1033 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001033)=0.000000000000000E+00 beta (00001034)=0.135640055638014E+02 gamma(00001034)=0.135640055638014E+02 lr_calc_dens: Charge drift due to real space implementation = -0.83759E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1034 z1= 1 -.348776206870969E-02 0.000000000000000E+00 z1= 2 -.281500760100371E-03 0.000000000000000E+00 z1= 3 -.918306178642618E-03 0.000000000000000E+00 alpha(00001034)=0.000000000000000E+00 beta (00001035)=0.129743623735628E+02 gamma(00001035)=0.129743623735628E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.32670E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1035 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001035)=0.000000000000000E+00 beta (00001036)=0.135777460971884E+02 gamma(00001036)=0.135777460971884E+02 lr_calc_dens: Charge drift due to real space implementation = 0.97938E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1036 z1= 1 0.354825357129789E-02 0.000000000000000E+00 z1= 2 0.286969839288847E-03 0.000000000000000E+00 z1= 3 0.942003438572432E-03 0.000000000000000E+00 alpha(00001036)=0.000000000000000E+00 beta (00001037)=0.129375611719009E+02 gamma(00001037)=0.129375611719009E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.32066E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1037 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001037)=0.000000000000000E+00 beta (00001038)=0.135746719373978E+02 gamma(00001038)=0.135746719373978E+02 lr_calc_dens: Charge drift due to real space implementation = -0.99486E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1038 z1= 1 -.374456416211760E-02 0.000000000000000E+00 z1= 2 -.291449750894292E-03 0.000000000000000E+00 z1= 3 -.963803934463687E-03 0.000000000000000E+00 alpha(00001038)=0.000000000000000E+00 beta (00001039)=0.129431895083293E+02 gamma(00001039)=0.129431895083293E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.31940E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1039 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001039)=0.000000000000000E+00 beta (00001040)=0.135518053585009E+02 gamma(00001040)=0.135518053585009E+02 lr_calc_dens: Charge drift due to real space implementation = 0.97988E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1040 z1= 1 0.401077673604221E-02 0.000000000000000E+00 z1= 2 0.297896001252079E-03 0.000000000000000E+00 z1= 3 0.989685668237021E-03 0.000000000000000E+00 alpha(00001040)=0.000000000000000E+00 beta (00001041)=0.129667501107373E+02 gamma(00001041)=0.129667501107373E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.31294E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1041 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001041)=0.000000000000000E+00 beta (00001042)=0.136064295312660E+02 gamma(00001042)=0.136064295312660E+02 lr_calc_dens: Charge drift due to real space implementation = -0.74074E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1042 z1= 1 -.431027980373332E-02 0.000000000000000E+00 z1= 2 -.303222274696926E-03 0.000000000000000E+00 z1= 3 -.101275587838743E-02 0.000000000000000E+00 alpha(00001042)=0.000000000000000E+00 beta (00001043)=0.129886027831670E+02 gamma(00001043)=0.129886027831670E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.33539E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1043 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001043)=0.000000000000000E+00 beta (00001044)=0.135618426406694E+02 gamma(00001044)=0.135618426406694E+02 lr_calc_dens: Charge drift due to real space implementation = 0.62893E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1044 z1= 1 0.456846224829221E-02 0.000000000000000E+00 z1= 2 0.312412394080886E-03 0.000000000000000E+00 z1= 3 0.104220244338333E-02 0.000000000000000E+00 alpha(00001044)=0.000000000000000E+00 beta (00001045)=0.130771400931868E+02 gamma(00001045)=0.130771400931868E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.36858E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1045 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001045)=0.000000000000000E+00 beta (00001046)=0.135759643058710E+02 gamma(00001046)=0.135759643058710E+02 lr_calc_dens: Charge drift due to real space implementation = -0.77379E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1046 z1= 1 -.471315166065720E-02 0.000000000000000E+00 z1= 2 -.321751099879445E-03 0.000000000000000E+00 z1= 3 -.107578473400797E-02 0.000000000000000E+00 alpha(00001046)=0.000000000000000E+00 beta (00001047)=0.130047299124689E+02 gamma(00001047)=0.130047299124689E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.38868E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1047 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001047)=0.000000000000000E+00 beta (00001048)=0.135993827792902E+02 gamma(00001048)=0.135993827792902E+02 lr_calc_dens: Charge drift due to real space implementation = 0.94897E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1048 z1= 1 0.473526452339488E-02 0.000000000000000E+00 z1= 2 0.327751305506912E-03 0.000000000000000E+00 z1= 3 0.110286280277409E-02 0.000000000000000E+00 alpha(00001048)=0.000000000000000E+00 beta (00001049)=0.129324797951584E+02 gamma(00001049)=0.129324797951584E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.39669E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1049 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001049)=0.000000000000000E+00 beta (00001050)=0.135729937188678E+02 gamma(00001050)=0.135729937188678E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10043E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1050 z1= 1 -.463871356829171E-02 0.000000000000000E+00 z1= 2 -.328826400170640E-03 0.000000000000000E+00 z1= 3 -.112697261940895E-02 0.000000000000000E+00 alpha(00001050)=0.000000000000000E+00 beta (00001051)=0.130032713133332E+02 gamma(00001051)=0.130032713133332E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.40201E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1051 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001051)=0.000000000000000E+00 beta (00001052)=0.135759069331540E+02 gamma(00001052)=0.135759069331540E+02 lr_calc_dens: Charge drift due to real space implementation = 0.98520E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1052 z1= 1 0.451404975822150E-02 0.000000000000000E+00 z1= 2 0.333142760566806E-03 0.000000000000000E+00 z1= 3 0.115900180024783E-02 0.000000000000000E+00 alpha(00001052)=0.000000000000000E+00 beta (00001053)=0.129553045273080E+02 gamma(00001053)=0.129553045273080E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.41636E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1053 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001053)=0.000000000000000E+00 beta (00001054)=0.135927443047999E+02 gamma(00001054)=0.135927443047999E+02 lr_calc_dens: Charge drift due to real space implementation = -0.94964E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1054 z1= 1 -.440766572599607E-02 0.000000000000000E+00 z1= 2 -.340687297263431E-03 0.000000000000000E+00 z1= 3 -.118606973167679E-02 0.000000000000000E+00 alpha(00001054)=0.000000000000000E+00 beta (00001055)=0.129123335952841E+02 gamma(00001055)=0.129123335952841E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.44600E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1055 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001055)=0.000000000000000E+00 beta (00001056)=0.134870433081502E+02 gamma(00001056)=0.134870433081502E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11077E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1056 z1= 1 0.433523016549518E-02 0.000000000000000E+00 z1= 2 0.351206681854856E-03 0.000000000000000E+00 z1= 3 0.122157645804146E-02 0.000000000000000E+00 alpha(00001056)=0.000000000000000E+00 beta (00001057)=0.129751640143322E+02 gamma(00001057)=0.129751640143322E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.45740E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1057 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001057)=0.000000000000000E+00 beta (00001058)=0.135413946280059E+02 gamma(00001058)=0.135413946280059E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12950E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1058 z1= 1 -.424126053826287E-02 0.000000000000000E+00 z1= 2 -.360695750381618E-03 0.000000000000000E+00 z1= 3 -.125752315037952E-02 0.000000000000000E+00 alpha(00001058)=0.000000000000000E+00 beta (00001059)=0.129768517868374E+02 gamma(00001059)=0.129768517868374E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.45340E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1059 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001059)=0.000000000000000E+00 beta (00001060)=0.134787763325132E+02 gamma(00001060)=0.134787763325132E+02 lr_calc_dens: Charge drift due to real space implementation = 0.13039E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1060 z1= 1 0.423542826685877E-02 0.000000000000000E+00 z1= 2 0.370330144778931E-03 0.000000000000000E+00 z1= 3 0.130082997892878E-02 0.000000000000000E+00 alpha(00001060)=0.000000000000000E+00 beta (00001061)=0.129735112596687E+02 gamma(00001061)=0.129735112596687E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.45553E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1061 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001061)=0.000000000000000E+00 beta (00001062)=0.134676919318458E+02 gamma(00001062)=0.134676919318458E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12869E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1062 z1= 1 -.420901420557491E-02 0.000000000000000E+00 z1= 2 -.381927370512690E-03 0.000000000000000E+00 z1= 3 -.134428192722598E-02 0.000000000000000E+00 alpha(00001062)=0.000000000000000E+00 beta (00001063)=0.129971554149332E+02 gamma(00001063)=0.129971554149332E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.45744E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1063 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001063)=0.000000000000000E+00 beta (00001064)=0.134403009249444E+02 gamma(00001064)=0.134403009249444E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11872E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1064 z1= 1 0.414642100099378E-02 0.000000000000000E+00 z1= 2 0.390692047816271E-03 0.000000000000000E+00 z1= 3 0.139317719058499E-02 0.000000000000000E+00 alpha(00001064)=0.000000000000000E+00 beta (00001065)=0.129664241437135E+02 gamma(00001065)=0.129664241437135E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.47356E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1065 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001065)=0.000000000000000E+00 beta (00001066)=0.133853594270634E+02 gamma(00001066)=0.133853594270634E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11779E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1066 z1= 1 -.413083042119564E-02 0.000000000000000E+00 z1= 2 -.404956265922782E-03 0.000000000000000E+00 z1= 3 -.144419873912378E-02 0.000000000000000E+00 alpha(00001066)=0.000000000000000E+00 beta (00001067)=0.131103479224003E+02 gamma(00001067)=0.131103479224003E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.48207E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1067 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001067)=0.000000000000000E+00 beta (00001068)=0.134197290594332E+02 gamma(00001068)=0.134197290594332E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11766E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1068 z1= 1 0.424530711644764E-02 0.000000000000000E+00 z1= 2 0.419934971054681E-03 0.000000000000000E+00 z1= 3 0.150626242625690E-02 0.000000000000000E+00 alpha(00001068)=0.000000000000000E+00 beta (00001069)=0.130167042173208E+02 gamma(00001069)=0.130167042173208E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.50257E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1069 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001069)=0.000000000000000E+00 beta (00001070)=0.134365381904111E+02 gamma(00001070)=0.134365381904111E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12617E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1070 z1= 1 -.446256538271136E-02 0.000000000000000E+00 z1= 2 -.432826713261693E-03 0.000000000000000E+00 z1= 3 -.155528535528700E-02 0.000000000000000E+00 alpha(00001070)=0.000000000000000E+00 beta (00001071)=0.129940789760107E+02 gamma(00001071)=0.129940789760107E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.52473E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1071 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001071)=0.000000000000000E+00 beta (00001072)=0.135325119034055E+02 gamma(00001072)=0.135325119034055E+02 lr_calc_dens: Charge drift due to real space implementation = 0.14625E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1072 z1= 1 0.472116118274491E-02 0.000000000000000E+00 z1= 2 0.438451999700692E-03 0.000000000000000E+00 z1= 3 0.159058559518663E-02 0.000000000000000E+00 alpha(00001072)=0.000000000000000E+00 beta (00001073)=0.129780213655014E+02 gamma(00001073)=0.129780213655014E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.53660E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1073 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001073)=0.000000000000000E+00 beta (00001074)=0.134706857327418E+02 gamma(00001074)=0.134706857327418E+02 lr_calc_dens: Charge drift due to real space implementation = -0.16323E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1074 z1= 1 -.503239264783009E-02 0.000000000000000E+00 z1= 2 -.445498802746016E-03 0.000000000000000E+00 z1= 3 -.163151870518518E-02 0.000000000000000E+00 alpha(00001074)=0.000000000000000E+00 beta (00001075)=0.129767958464198E+02 gamma(00001075)=0.129767958464198E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.53721E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1075 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001075)=0.000000000000000E+00 beta (00001076)=0.134463338570340E+02 gamma(00001076)=0.134463338570340E+02 lr_calc_dens: Charge drift due to real space implementation = 0.16988E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1076 z1= 1 0.524991629473186E-02 0.000000000000000E+00 z1= 2 0.453485656112309E-03 0.000000000000000E+00 z1= 3 0.167564014904706E-02 0.000000000000000E+00 alpha(00001076)=0.000000000000000E+00 beta (00001077)=0.129528100164153E+02 gamma(00001077)=0.129528100164153E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.53736E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1077 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001077)=0.000000000000000E+00 beta (00001078)=0.134739066541427E+02 gamma(00001078)=0.134739066541427E+02 lr_calc_dens: Charge drift due to real space implementation = -0.16734E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1078 z1= 1 -.534577331705655E-02 0.000000000000000E+00 z1= 2 -.461862238840740E-03 0.000000000000000E+00 z1= 3 -.171346443949905E-02 0.000000000000000E+00 alpha(00001078)=0.000000000000000E+00 beta (00001079)=0.131037815810848E+02 gamma(00001079)=0.131037815810848E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.53758E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1079 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001079)=0.000000000000000E+00 beta (00001080)=0.135065553604358E+02 gamma(00001080)=0.135065553604358E+02 lr_calc_dens: Charge drift due to real space implementation = 0.16229E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1080 z1= 1 0.548038248929321E-02 0.000000000000000E+00 z1= 2 0.471640455842731E-03 0.000000000000000E+00 z1= 3 0.176620572961891E-02 0.000000000000000E+00 alpha(00001080)=0.000000000000000E+00 beta (00001081)=0.130968082422923E+02 gamma(00001081)=0.130968082422923E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.54798E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1081 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001081)=0.000000000000000E+00 beta (00001082)=0.135052309703721E+02 gamma(00001082)=0.135052309703721E+02 lr_calc_dens: Charge drift due to real space implementation = -0.16232E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1082 z1= 1 -.569952251744753E-02 0.000000000000000E+00 z1= 2 -.481964679373832E-03 0.000000000000000E+00 z1= 3 -.181737838423065E-02 0.000000000000000E+00 alpha(00001082)=0.000000000000000E+00 beta (00001083)=0.131195703827076E+02 gamma(00001083)=0.131195703827076E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.56111E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1083 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001083)=0.000000000000000E+00 beta (00001084)=0.135270771526832E+02 gamma(00001084)=0.135270771526832E+02 lr_calc_dens: Charge drift due to real space implementation = 0.17205E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1084 z1= 1 0.606798692971451E-02 0.000000000000000E+00 z1= 2 0.488577981784898E-03 0.000000000000000E+00 z1= 3 0.186804550915138E-02 0.000000000000000E+00 alpha(00001084)=0.000000000000000E+00 beta (00001085)=0.131080263616259E+02 gamma(00001085)=0.131080263616259E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.56805E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1085 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001085)=0.000000000000000E+00 beta (00001086)=0.134076733433802E+02 gamma(00001086)=0.134076733433802E+02 lr_calc_dens: Charge drift due to real space implementation = -0.18047E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1086 z1= 1 -.659690170848102E-02 0.000000000000000E+00 z1= 2 -.502197414850285E-03 0.000000000000000E+00 z1= 3 -.193261585856596E-02 0.000000000000000E+00 alpha(00001086)=0.000000000000000E+00 beta (00001087)=0.130802963422519E+02 gamma(00001087)=0.130802963422519E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.56977E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1087 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001087)=0.000000000000000E+00 beta (00001088)=0.134666894504564E+02 gamma(00001088)=0.134666894504564E+02 lr_calc_dens: Charge drift due to real space implementation = 0.18201E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1088 z1= 1 0.710105108830170E-02 0.000000000000000E+00 z1= 2 0.514942193711165E-03 0.000000000000000E+00 z1= 3 0.198335683407780E-02 0.000000000000000E+00 alpha(00001088)=0.000000000000000E+00 beta (00001089)=0.131181858262338E+02 gamma(00001089)=0.131181858262338E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.57967E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1089 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001089)=0.000000000000000E+00 beta (00001090)=0.134286871471092E+02 gamma(00001090)=0.134286871471092E+02 lr_calc_dens: Charge drift due to real space implementation = -0.19038E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1090 z1= 1 -.756806364880285E-02 0.000000000000000E+00 z1= 2 -.528182873022803E-03 0.000000000000000E+00 z1= 3 -.204406977107306E-02 0.000000000000000E+00 alpha(00001090)=0.000000000000000E+00 beta (00001091)=0.129653067647422E+02 gamma(00001091)=0.129653067647422E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.59277E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1091 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001091)=0.000000000000000E+00 beta (00001092)=0.134023063319062E+02 gamma(00001092)=0.134023063319062E+02 lr_calc_dens: Charge drift due to real space implementation = 0.19798E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1092 z1= 1 0.780714835858082E-02 0.000000000000000E+00 z1= 2 0.536237126720414E-03 0.000000000000000E+00 z1= 3 0.208578835052943E-02 0.000000000000000E+00 alpha(00001092)=0.000000000000000E+00 beta (00001093)=0.130211954309256E+02 gamma(00001093)=0.130211954309256E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.60150E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1093 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001093)=0.000000000000000E+00 beta (00001094)=0.134365812716783E+02 gamma(00001094)=0.134365812716783E+02 lr_calc_dens: Charge drift due to real space implementation = -0.20741E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1094 z1= 1 -.783495460676866E-02 0.000000000000000E+00 z1= 2 -.546844713596132E-03 0.000000000000000E+00 z1= 3 -.212933971340904E-02 0.000000000000000E+00 alpha(00001094)=0.000000000000000E+00 beta (00001095)=0.130611807579483E+02 gamma(00001095)=0.130611807579483E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.60826E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1095 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001095)=0.000000000000000E+00 beta (00001096)=0.134335816363649E+02 gamma(00001096)=0.134335816363649E+02 lr_calc_dens: Charge drift due to real space implementation = 0.22159E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1096 z1= 1 0.765622612433255E-02 0.000000000000000E+00 z1= 2 0.558631854932583E-03 0.000000000000000E+00 z1= 3 0.217865073393639E-02 0.000000000000000E+00 alpha(00001096)=0.000000000000000E+00 beta (00001097)=0.130892486646489E+02 gamma(00001097)=0.130892486646489E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.60019E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1097 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001097)=0.000000000000000E+00 beta (00001098)=0.134378376368760E+02 gamma(00001098)=0.134378376368760E+02 lr_calc_dens: Charge drift due to real space implementation = -0.22143E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1098 z1= 1 -.732792545319476E-02 0.000000000000000E+00 z1= 2 -.568706097951702E-03 0.000000000000000E+00 z1= 3 -.223004526424059E-02 0.000000000000000E+00 alpha(00001098)=0.000000000000000E+00 beta (00001099)=0.130627483101087E+02 gamma(00001099)=0.130627483101087E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.60058E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1099 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001099)=0.000000000000000E+00 beta (00001100)=0.134393781466803E+02 gamma(00001100)=0.134393781466803E+02 lr_calc_dens: Charge drift due to real space implementation = 0.22066E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1100 z1= 1 0.691784872373430E-02 0.000000000000000E+00 z1= 2 0.579417229705505E-03 0.000000000000000E+00 z1= 3 0.227600264482607E-02 0.000000000000000E+00 alpha(00001100)=0.000000000000000E+00 beta (00001101)=0.130455719944497E+02 gamma(00001101)=0.130455719944497E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.60746E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1101 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001101)=0.000000000000000E+00 beta (00001102)=0.134560103880567E+02 gamma(00001102)=0.134560103880567E+02 lr_calc_dens: Charge drift due to real space implementation = -0.22780E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1102 z1= 1 -.647106777171173E-02 0.000000000000000E+00 z1= 2 -.588074838746526E-03 0.000000000000000E+00 z1= 3 -.231507691243529E-02 0.000000000000000E+00 alpha(00001102)=0.000000000000000E+00 beta (00001103)=0.130391676701482E+02 gamma(00001103)=0.130391676701482E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.60895E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1103 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001103)=0.000000000000000E+00 beta (00001104)=0.133436779747888E+02 gamma(00001104)=0.133436779747888E+02 lr_calc_dens: Charge drift due to real space implementation = 0.23206E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1104 z1= 1 0.604093692954567E-02 0.000000000000000E+00 z1= 2 0.600315760835977E-03 0.000000000000000E+00 z1= 3 0.237332861271796E-02 0.000000000000000E+00 alpha(00001104)=0.000000000000000E+00 beta (00001105)=0.131237204672457E+02 gamma(00001105)=0.131237204672457E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.60685E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1105 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001105)=0.000000000000000E+00 beta (00001106)=0.133699635966833E+02 gamma(00001106)=0.133699635966833E+02 lr_calc_dens: Charge drift due to real space implementation = -0.24308E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1106 z1= 1 -.566558845525479E-02 0.000000000000000E+00 z1= 2 -.614279648006031E-03 0.000000000000000E+00 z1= 3 -.243995177648994E-02 0.000000000000000E+00 alpha(00001106)=0.000000000000000E+00 beta (00001107)=0.130275328371478E+02 gamma(00001107)=0.130275328371478E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.60652E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1107 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001107)=0.000000000000000E+00 beta (00001108)=0.134702800509062E+02 gamma(00001108)=0.134702800509062E+02 lr_calc_dens: Charge drift due to real space implementation = 0.24942E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1108 z1= 1 0.526544905905026E-02 0.000000000000000E+00 z1= 2 0.619197720061792E-03 0.000000000000000E+00 z1= 3 0.246995776453574E-02 0.000000000000000E+00 alpha(00001108)=0.000000000000000E+00 beta (00001109)=0.130163090107102E+02 gamma(00001109)=0.130163090107102E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.60663E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1109 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001109)=0.000000000000000E+00 beta (00001110)=0.134110893267423E+02 gamma(00001110)=0.134110893267423E+02 lr_calc_dens: Charge drift due to real space implementation = -0.24353E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1110 z1= 1 -.493758404601516E-02 0.000000000000000E+00 z1= 2 -.627065794821439E-03 0.000000000000000E+00 z1= 3 -.250806735779584E-02 0.000000000000000E+00 alpha(00001110)=0.000000000000000E+00 beta (00001111)=0.130668139018180E+02 gamma(00001111)=0.130668139018180E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.61444E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1111 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001111)=0.000000000000000E+00 beta (00001112)=0.133317126268328E+02 gamma(00001112)=0.133317126268328E+02 lr_calc_dens: Charge drift due to real space implementation = 0.24391E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1112 z1= 1 0.465657746965901E-02 0.000000000000000E+00 z1= 2 0.641243784518131E-03 0.000000000000000E+00 z1= 3 0.256901365996820E-02 0.000000000000000E+00 alpha(00001112)=0.000000000000000E+00 beta (00001113)=0.131975015366922E+02 gamma(00001113)=0.131975015366922E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.61570E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1113 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001113)=0.000000000000000E+00 beta (00001114)=0.134326822613512E+02 gamma(00001114)=0.134326822613512E+02 lr_calc_dens: Charge drift due to real space implementation = -0.24929E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1114 z1= 1 -.435920975394941E-02 0.000000000000000E+00 z1= 2 -.655771877628124E-03 0.000000000000000E+00 z1= 3 -.263038903273766E-02 0.000000000000000E+00 alpha(00001114)=0.000000000000000E+00 beta (00001115)=0.131060979745339E+02 gamma(00001115)=0.131060979745339E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.62636E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1115 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001115)=0.000000000000000E+00 beta (00001116)=0.134478437434077E+02 gamma(00001116)=0.134478437434077E+02 lr_calc_dens: Charge drift due to real space implementation = 0.25905E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1116 z1= 1 0.400534543454278E-02 0.000000000000000E+00 z1= 2 0.661680031891099E-03 0.000000000000000E+00 z1= 3 0.266869167140879E-02 0.000000000000000E+00 alpha(00001116)=0.000000000000000E+00 beta (00001117)=0.131068902982149E+02 gamma(00001117)=0.131068902982149E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.63467E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1117 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001117)=0.000000000000000E+00 beta (00001118)=0.134458926421154E+02 gamma(00001118)=0.134458926421154E+02 lr_calc_dens: Charge drift due to real space implementation = -0.27963E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1118 z1= 1 -.372332821346270E-02 0.000000000000000E+00 z1= 2 -.670734884924687E-03 0.000000000000000E+00 z1= 3 -.270464339778507E-02 0.000000000000000E+00 alpha(00001118)=0.000000000000000E+00 beta (00001119)=0.131371827886517E+02 gamma(00001119)=0.131371827886517E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.62067E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1119 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001119)=0.000000000000000E+00 beta (00001120)=0.133379414693770E+02 gamma(00001120)=0.133379414693770E+02 lr_calc_dens: Charge drift due to real space implementation = 0.28772E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1120 z1= 1 0.359946666939740E-02 0.000000000000000E+00 z1= 2 0.687443283876822E-03 0.000000000000000E+00 z1= 3 0.276722140674687E-02 0.000000000000000E+00 alpha(00001120)=0.000000000000000E+00 beta (00001121)=0.131754988838343E+02 gamma(00001121)=0.131754988838343E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.60008E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1121 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001121)=0.000000000000000E+00 beta (00001122)=0.134326747455828E+02 gamma(00001122)=0.134326747455828E+02 lr_calc_dens: Charge drift due to real space implementation = -0.28310E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1122 z1= 1 -.357236679537361E-02 0.000000000000000E+00 z1= 2 -.698571927528712E-03 0.000000000000000E+00 z1= 3 -.281405233243801E-02 0.000000000000000E+00 alpha(00001122)=0.000000000000000E+00 beta (00001123)=0.130610092575751E+02 gamma(00001123)=0.130610092575751E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.60231E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1123 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001123)=0.000000000000000E+00 beta (00001124)=0.133322317351912E+02 gamma(00001124)=0.133322317351912E+02 lr_calc_dens: Charge drift due to real space implementation = 0.28303E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1124 z1= 1 0.365316275871850E-02 0.000000000000000E+00 z1= 2 0.707057974105772E-03 0.000000000000000E+00 z1= 3 0.285752896143216E-02 0.000000000000000E+00 alpha(00001124)=0.000000000000000E+00 beta (00001125)=0.131058716081648E+02 gamma(00001125)=0.131058716081648E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.60324E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1125 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001125)=0.000000000000000E+00 beta (00001126)=0.134652559443213E+02 gamma(00001126)=0.134652559443213E+02 lr_calc_dens: Charge drift due to real space implementation = -0.28846E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1126 z1= 1 -.380757770386356E-02 0.000000000000000E+00 z1= 2 -.712911009278372E-03 0.000000000000000E+00 z1= 3 -.287906868373359E-02 0.000000000000000E+00 alpha(00001126)=0.000000000000000E+00 beta (00001127)=0.131414867608950E+02 gamma(00001127)=0.131414867608950E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.60647E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1127 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001127)=0.000000000000000E+00 beta (00001128)=0.133847681064818E+02 gamma(00001128)=0.133847681064818E+02 lr_calc_dens: Charge drift due to real space implementation = 0.30309E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1128 z1= 1 0.408912207378145E-02 0.000000000000000E+00 z1= 2 0.722656327161734E-03 0.000000000000000E+00 z1= 3 0.292433183940471E-02 0.000000000000000E+00 alpha(00001128)=0.000000000000000E+00 beta (00001129)=0.131822945245400E+02 gamma(00001129)=0.131822945245400E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.59317E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1129 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001129)=0.000000000000000E+00 beta (00001130)=0.133340557610119E+02 gamma(00001130)=0.133340557610119E+02 lr_calc_dens: Charge drift due to real space implementation = -0.31041E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1130 z1= 1 -.441872218569863E-02 0.000000000000000E+00 z1= 2 -.740932630210141E-03 0.000000000000000E+00 z1= 3 -.298589880480404E-02 0.000000000000000E+00 alpha(00001130)=0.000000000000000E+00 beta (00001131)=0.131424919063501E+02 gamma(00001131)=0.131424919063501E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.58468E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1131 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001131)=0.000000000000000E+00 beta (00001132)=0.134040670074114E+02 gamma(00001132)=0.134040670074114E+02 lr_calc_dens: Charge drift due to real space implementation = 0.32154E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1132 z1= 1 0.461931686346528E-02 0.000000000000000E+00 z1= 2 0.751503728730926E-03 0.000000000000000E+00 z1= 3 0.301991745658717E-02 0.000000000000000E+00 alpha(00001132)=0.000000000000000E+00 beta (00001133)=0.132014692310987E+02 gamma(00001133)=0.132014692310987E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.56576E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1133 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001133)=0.000000000000000E+00 beta (00001134)=0.134333174013587E+02 gamma(00001134)=0.134333174013587E+02 lr_calc_dens: Charge drift due to real space implementation = -0.32491E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1134 z1= 1 -.477186056702689E-02 0.000000000000000E+00 z1= 2 -.762151541247065E-03 0.000000000000000E+00 z1= 3 -.305674345807662E-02 0.000000000000000E+00 alpha(00001134)=0.000000000000000E+00 beta (00001135)=0.132159723070312E+02 gamma(00001135)=0.132159723070312E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.54812E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1135 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001135)=0.000000000000000E+00 beta (00001136)=0.133045540699127E+02 gamma(00001136)=0.133045540699127E+02 lr_calc_dens: Charge drift due to real space implementation = 0.32362E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1136 z1= 1 0.495373129335370E-02 0.000000000000000E+00 z1= 2 0.775393200223913E-03 0.000000000000000E+00 z1= 3 0.312403657306543E-02 0.000000000000000E+00 alpha(00001136)=0.000000000000000E+00 beta (00001137)=0.132524724574011E+02 gamma(00001137)=0.132524724574011E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.53752E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1137 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001137)=0.000000000000000E+00 beta (00001138)=0.133589747656521E+02 gamma(00001138)=0.133589747656521E+02 lr_calc_dens: Charge drift due to real space implementation = -0.33447E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1138 z1= 1 -.507371415023725E-02 0.000000000000000E+00 z1= 2 -.789733579755173E-03 0.000000000000000E+00 z1= 3 -.318249163734832E-02 0.000000000000000E+00 alpha(00001138)=0.000000000000000E+00 beta (00001139)=0.131355127650019E+02 gamma(00001139)=0.131355127650019E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.52265E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1139 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001139)=0.000000000000000E+00 beta (00001140)=0.133586748662084E+02 gamma(00001140)=0.133586748662084E+02 lr_calc_dens: Charge drift due to real space implementation = 0.32902E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1140 z1= 1 0.513371110258347E-02 0.000000000000000E+00 z1= 2 0.797302160672536E-03 0.000000000000000E+00 z1= 3 0.321056247493484E-02 0.000000000000000E+00 alpha(00001140)=0.000000000000000E+00 beta (00001141)=0.131425422170474E+02 gamma(00001141)=0.131425422170474E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.51919E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1141 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001141)=0.000000000000000E+00 beta (00001142)=0.134590326816614E+02 gamma(00001142)=0.134590326816614E+02 lr_calc_dens: Charge drift due to real space implementation = -0.32565E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1142 z1= 1 -.512319075824965E-02 0.000000000000000E+00 z1= 2 -.800563332518918E-03 0.000000000000000E+00 z1= 3 -.321294349555036E-02 0.000000000000000E+00 alpha(00001142)=0.000000000000000E+00 beta (00001143)=0.130694651998090E+02 gamma(00001143)=0.130694651998090E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.52717E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1143 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001143)=0.000000000000000E+00 beta (00001144)=0.133713228843397E+02 gamma(00001144)=0.133713228843397E+02 lr_calc_dens: Charge drift due to real space implementation = 0.33611E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1144 z1= 1 0.504716146440068E-02 0.000000000000000E+00 z1= 2 0.800521107559397E-03 0.000000000000000E+00 z1= 3 0.321787084805355E-02 0.000000000000000E+00 alpha(00001144)=0.000000000000000E+00 beta (00001145)=0.130616135558038E+02 gamma(00001145)=0.130616135558038E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.51350E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1145 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001145)=0.000000000000000E+00 beta (00001146)=0.134781443699047E+02 gamma(00001146)=0.134781443699047E+02 lr_calc_dens: Charge drift due to real space implementation = -0.32637E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1146 z1= 1 -.473903662222586E-02 0.000000000000000E+00 z1= 2 -.793197852194368E-03 0.000000000000000E+00 z1= 3 -.319351841291264E-02 0.000000000000000E+00 alpha(00001146)=0.000000000000000E+00 beta (00001147)=0.130464812473704E+02 gamma(00001147)=0.130464812473704E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.51978E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1147 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001147)=0.000000000000000E+00 beta (00001148)=0.133637306055223E+02 gamma(00001148)=0.133637306055223E+02 lr_calc_dens: Charge drift due to real space implementation = 0.33009E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1148 z1= 1 0.426340685029633E-02 0.000000000000000E+00 z1= 2 0.786844210767264E-03 0.000000000000000E+00 z1= 3 0.319251550608191E-02 0.000000000000000E+00 alpha(00001148)=0.000000000000000E+00 beta (00001149)=0.131544711526307E+02 gamma(00001149)=0.131544711526307E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.51680E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1149 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001149)=0.000000000000000E+00 beta (00001150)=0.133194834705876E+02 gamma(00001150)=0.133194834705876E+02 lr_calc_dens: Charge drift due to real space implementation = -0.35174E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1150 z1= 1 -.384921626444468E-02 0.000000000000000E+00 z1= 2 -.789338527040246E-03 0.000000000000000E+00 z1= 3 -.322608700268014E-02 0.000000000000000E+00 alpha(00001150)=0.000000000000000E+00 beta (00001151)=0.130964329547807E+02 gamma(00001151)=0.130964329547807E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.49306E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1151 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001151)=0.000000000000000E+00 beta (00001152)=0.134354931796899E+02 gamma(00001152)=0.134354931796899E+02 lr_calc_dens: Charge drift due to real space implementation = 0.35145E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1152 z1= 1 0.344707434150552E-02 0.000000000000000E+00 z1= 2 0.782731437618625E-03 0.000000000000000E+00 z1= 3 0.321440496593533E-02 0.000000000000000E+00 alpha(00001152)=0.000000000000000E+00 beta (00001153)=0.131388074562563E+02 gamma(00001153)=0.131388074562563E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.47820E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1153 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001153)=0.000000000000000E+00 beta (00001154)=0.134736372970502E+02 gamma(00001154)=0.134736372970502E+02 lr_calc_dens: Charge drift due to real space implementation = -0.34615E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1154 z1= 1 -.310211198064230E-02 0.000000000000000E+00 z1= 2 -.775157142966391E-03 0.000000000000000E+00 z1= 3 -.320156073938219E-02 0.000000000000000E+00 alpha(00001154)=0.000000000000000E+00 beta (00001155)=0.130475475097883E+02 gamma(00001155)=0.130475475097883E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.47686E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1155 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001155)=0.000000000000000E+00 beta (00001156)=0.134870375189350E+02 gamma(00001156)=0.134870375189350E+02 lr_calc_dens: Charge drift due to real space implementation = 0.34391E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1156 z1= 1 0.280018271903059E-02 0.000000000000000E+00 z1= 2 0.760471662740731E-03 0.000000000000000E+00 z1= 3 0.316208672388135E-02 0.000000000000000E+00 alpha(00001156)=0.000000000000000E+00 beta (00001157)=0.131301805812136E+02 gamma(00001157)=0.131301805812136E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.47187E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1157 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001157)=0.000000000000000E+00 beta (00001158)=0.134575973947947E+02 gamma(00001158)=0.134575973947947E+02 lr_calc_dens: Charge drift due to real space implementation = -0.34597E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1158 z1= 1 -.247306966141164E-02 0.000000000000000E+00 z1= 2 -.753613095846856E-03 0.000000000000000E+00 z1= 3 -.314801736817901E-02 0.000000000000000E+00 alpha(00001158)=0.000000000000000E+00 beta (00001159)=0.130393823198495E+02 gamma(00001159)=0.130393823198495E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.46679E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1159 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001159)=0.000000000000000E+00 beta (00001160)=0.134261491031616E+02 gamma(00001160)=0.134261491031616E+02 lr_calc_dens: Charge drift due to real space implementation = 0.34474E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1160 z1= 1 0.204375773652154E-02 0.000000000000000E+00 z1= 2 0.739164761961634E-03 0.000000000000000E+00 z1= 3 0.311770917989083E-02 0.000000000000000E+00 alpha(00001160)=0.000000000000000E+00 beta (00001161)=0.130808375692653E+02 gamma(00001161)=0.130808375692653E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.45835E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1161 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001161)=0.000000000000000E+00 beta (00001162)=0.134907923503079E+02 gamma(00001162)=0.134907923503079E+02 lr_calc_dens: Charge drift due to real space implementation = -0.34167E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1162 z1= 1 -.156089537893974E-02 0.000000000000000E+00 z1= 2 -.722734007630753E-03 0.000000000000000E+00 z1= 3 -.308050789233295E-02 0.000000000000000E+00 alpha(00001162)=0.000000000000000E+00 beta (00001163)=0.131340989055631E+02 gamma(00001163)=0.131340989055631E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.44477E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1163 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001163)=0.000000000000000E+00 beta (00001164)=0.135236217943121E+02 gamma(00001164)=0.135236217943121E+02 lr_calc_dens: Charge drift due to real space implementation = 0.32584E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1164 z1= 1 0.116914929933242E-02 0.000000000000000E+00 z1= 2 0.708111896673677E-03 0.000000000000000E+00 z1= 3 0.304604240015562E-02 0.000000000000000E+00 alpha(00001164)=0.000000000000000E+00 beta (00001165)=0.130329748368519E+02 gamma(00001165)=0.130329748368519E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.45216E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1165 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001165)=0.000000000000000E+00 beta (00001166)=0.134382208097163E+02 gamma(00001166)=0.134382208097163E+02 lr_calc_dens: Charge drift due to real space implementation = -0.32091E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1166 z1= 1 -.914305604566422E-03 0.000000000000000E+00 z1= 2 -.690056796155056E-03 0.000000000000000E+00 z1= 3 -.300681436247121E-02 0.000000000000000E+00 alpha(00001166)=0.000000000000000E+00 beta (00001167)=0.130825081448183E+02 gamma(00001167)=0.130825081448183E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.45978E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1167 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001167)=0.000000000000000E+00 beta (00001168)=0.135307635363699E+02 gamma(00001168)=0.135307635363699E+02 lr_calc_dens: Charge drift due to real space implementation = 0.33225E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1168 z1= 1 0.811172475873465E-03 0.000000000000000E+00 z1= 2 0.672953369550231E-03 0.000000000000000E+00 z1= 3 0.295646086235810E-02 0.000000000000000E+00 alpha(00001168)=0.000000000000000E+00 beta (00001169)=0.130588227381211E+02 gamma(00001169)=0.130588227381211E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.46052E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1169 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001169)=0.000000000000000E+00 beta (00001170)=0.134206131677659E+02 gamma(00001170)=0.134206131677659E+02 lr_calc_dens: Charge drift due to real space implementation = -0.35325E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1170 z1= 1 -.895173498411856E-03 0.000000000000000E+00 z1= 2 -.660145730681202E-03 0.000000000000000E+00 z1= 3 -.292502777496975E-02 0.000000000000000E+00 alpha(00001170)=0.000000000000000E+00 beta (00001171)=0.130891275256623E+02 gamma(00001171)=0.130891275256623E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.43120E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1171 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001171)=0.000000000000000E+00 beta (00001172)=0.136115887454023E+02 gamma(00001172)=0.136115887454023E+02 lr_calc_dens: Charge drift due to real space implementation = 0.34500E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1172 z1= 1 0.101521773076239E-02 0.000000000000000E+00 z1= 2 0.635993379055318E-03 0.000000000000000E+00 z1= 3 0.285708410449942E-02 0.000000000000000E+00 alpha(00001172)=0.000000000000000E+00 beta (00001173)=0.130144880291217E+02 gamma(00001173)=0.130144880291217E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.41610E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1173 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001173)=0.000000000000000E+00 beta (00001174)=0.134614136142631E+02 gamma(00001174)=0.134614136142631E+02 lr_calc_dens: Charge drift due to real space implementation = -0.32178E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1174 z1= 1 -.108483212756655E-02 0.000000000000000E+00 z1= 2 -.615145384906092E-03 0.000000000000000E+00 z1= 3 -.280597162135647E-02 0.000000000000000E+00 alpha(00001174)=0.000000000000000E+00 beta (00001175)=0.130365413401310E+02 gamma(00001175)=0.130365413401310E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.42274E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1175 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001175)=0.000000000000000E+00 beta (00001176)=0.134586346273762E+02 gamma(00001176)=0.134586346273762E+02 lr_calc_dens: Charge drift due to real space implementation = 0.31858E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1176 z1= 1 0.100464321901874E-02 0.000000000000000E+00 z1= 2 0.599017268492463E-03 0.000000000000000E+00 z1= 3 0.275919927095465E-02 0.000000000000000E+00 alpha(00001176)=0.000000000000000E+00 beta (00001177)=0.129588421477010E+02 gamma(00001177)=0.129588421477010E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.42695E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1177 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001177)=0.000000000000000E+00 beta (00001178)=0.135075813976629E+02 gamma(00001178)=0.135075813976629E+02 lr_calc_dens: Charge drift due to real space implementation = -0.31346E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1178 z1= 1 -.763749175997539E-03 0.000000000000000E+00 z1= 2 -.573478165657089E-03 0.000000000000000E+00 z1= 3 -.268703023759315E-02 0.000000000000000E+00 alpha(00001178)=0.000000000000000E+00 beta (00001179)=0.130583275566608E+02 gamma(00001179)=0.130583275566608E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.42894E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1179 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001179)=0.000000000000000E+00 beta (00001180)=0.134207712219181E+02 gamma(00001180)=0.134207712219181E+02 lr_calc_dens: Charge drift due to real space implementation = 0.31524E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1180 z1= 1 0.445383944122604E-03 0.000000000000000E+00 z1= 2 0.559453179071596E-03 0.000000000000000E+00 z1= 3 0.265196570818712E-02 0.000000000000000E+00 alpha(00001180)=0.000000000000000E+00 beta (00001181)=0.130761371907646E+02 gamma(00001181)=0.130761371907646E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.42384E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1181 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001181)=0.000000000000000E+00 beta (00001182)=0.134295656284057E+02 gamma(00001182)=0.134295656284057E+02 lr_calc_dens: Charge drift due to real space implementation = -0.31557E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1182 z1= 1 -.102282237085364E-03 0.000000000000000E+00 z1= 2 -.546453531528683E-03 0.000000000000000E+00 z1= 3 -.261771371070506E-02 0.000000000000000E+00 alpha(00001182)=0.000000000000000E+00 beta (00001183)=0.129340814678118E+02 gamma(00001183)=0.129340814678118E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.42338E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1183 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001183)=0.000000000000000E+00 beta (00001184)=0.134726972300380E+02 gamma(00001184)=0.134726972300380E+02 lr_calc_dens: Charge drift due to real space implementation = 0.31739E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1184 z1= 1 -.151442253646885E-03 0.000000000000000E+00 z1= 2 0.524513777442141E-03 0.000000000000000E+00 z1= 3 0.254551362436855E-02 0.000000000000000E+00 alpha(00001184)=0.000000000000000E+00 beta (00001185)=0.129723329313082E+02 gamma(00001185)=0.129723329313082E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.41103E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1185 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001185)=0.000000000000000E+00 beta (00001186)=0.134446929479978E+02 gamma(00001186)=0.134446929479978E+02 lr_calc_dens: Charge drift due to real space implementation = -0.30852E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1186 z1= 1 0.350410211085009E-03 0.000000000000000E+00 z1= 2 -.501948024851111E-03 0.000000000000000E+00 z1= 3 -.248698084192345E-02 0.000000000000000E+00 alpha(00001186)=0.000000000000000E+00 beta (00001187)=0.129898493540411E+02 gamma(00001187)=0.129898493540411E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.40784E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1187 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001187)=0.000000000000000E+00 beta (00001188)=0.134533399780031E+02 gamma(00001188)=0.134533399780031E+02 lr_calc_dens: Charge drift due to real space implementation = 0.30539E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1188 z1= 1 -.661651483906038E-03 0.000000000000000E+00 z1= 2 0.478149566716721E-03 0.000000000000000E+00 z1= 3 0.242951165632493E-02 0.000000000000000E+00 alpha(00001188)=0.000000000000000E+00 beta (00001189)=0.129725098048245E+02 gamma(00001189)=0.129725098048245E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.40849E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1189 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001189)=0.000000000000000E+00 beta (00001190)=0.134583356698445E+02 gamma(00001190)=0.134583356698445E+02 lr_calc_dens: Charge drift due to real space implementation = -0.30873E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1190 z1= 1 0.103555504833054E-02 0.000000000000000E+00 z1= 2 -.457919048475669E-03 0.000000000000000E+00 z1= 3 -.236879610328444E-02 0.000000000000000E+00 alpha(00001190)=0.000000000000000E+00 beta (00001191)=0.129770365449341E+02 gamma(00001191)=0.129770365449341E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.40517E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1191 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001191)=0.000000000000000E+00 beta (00001192)=0.133516263695627E+02 gamma(00001192)=0.133516263695627E+02 lr_calc_dens: Charge drift due to real space implementation = 0.31486E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1192 z1= 1 -.142358792273611E-02 0.000000000000000E+00 z1= 2 0.441252693019246E-03 0.000000000000000E+00 z1= 3 0.232652189213799E-02 0.000000000000000E+00 alpha(00001192)=0.000000000000000E+00 beta (00001193)=0.129907828255300E+02 gamma(00001193)=0.129907828255300E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.39078E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1193 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001193)=0.000000000000000E+00 beta (00001194)=0.134582982972088E+02 gamma(00001194)=0.134582982972088E+02 lr_calc_dens: Charge drift due to real space implementation = -0.30575E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1194 z1= 1 0.180703966422919E-02 0.000000000000000E+00 z1= 2 -.417437107332744E-03 0.000000000000000E+00 z1= 3 -.226800347351425E-02 0.000000000000000E+00 alpha(00001194)=0.000000000000000E+00 beta (00001195)=0.130611702657366E+02 gamma(00001195)=0.130611702657366E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.38670E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1195 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001195)=0.000000000000000E+00 beta (00001196)=0.135098224995514E+02 gamma(00001196)=0.135098224995514E+02 lr_calc_dens: Charge drift due to real space implementation = 0.29941E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1196 z1= 1 -.219585897752922E-02 0.000000000000000E+00 z1= 2 0.398965532364107E-03 0.000000000000000E+00 z1= 3 0.221043260204207E-02 0.000000000000000E+00 alpha(00001196)=0.000000000000000E+00 beta (00001197)=0.130437332644823E+02 gamma(00001197)=0.130437332644823E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.38911E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1197 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001197)=0.000000000000000E+00 beta (00001198)=0.135027149641263E+02 gamma(00001198)=0.135027149641263E+02 lr_calc_dens: Charge drift due to real space implementation = -0.30676E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1198 z1= 1 0.258648236771863E-02 0.000000000000000E+00 z1= 2 -.382764221004320E-03 0.000000000000000E+00 z1= 3 -.215134166965455E-02 0.000000000000000E+00 alpha(00001198)=0.000000000000000E+00 beta (00001199)=0.131255171076260E+02 gamma(00001199)=0.131255171076260E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.36534E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1199 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001199)=0.000000000000000E+00 beta (00001200)=0.134405134193643E+02 gamma(00001200)=0.134405134193643E+02 lr_calc_dens: Charge drift due to real space implementation = 0.29288E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1200 z1= 1 -.296913311449529E-02 0.000000000000000E+00 z1= 2 0.366661760750422E-03 0.000000000000000E+00 z1= 3 0.211287129486784E-02 0.000000000000000E+00 alpha(00001200)=0.000000000000000E+00 beta (00001201)=0.130179697868687E+02 gamma(00001201)=0.130179697868687E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.35526E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1201 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001201)=0.000000000000000E+00 beta (00001202)=0.134425365719523E+02 gamma(00001202)=0.134425365719523E+02 lr_calc_dens: Charge drift due to real space implementation = -0.27161E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1202 z1= 1 0.328255897038140E-02 0.000000000000000E+00 z1= 2 -.347548056238415E-03 0.000000000000000E+00 z1= 3 -.205705001258590E-02 0.000000000000000E+00 alpha(00001202)=0.000000000000000E+00 beta (00001203)=0.130664321083658E+02 gamma(00001203)=0.130664321083658E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.36569E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1203 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001203)=0.000000000000000E+00 beta (00001204)=0.135309232789387E+02 gamma(00001204)=0.135309232789387E+02 lr_calc_dens: Charge drift due to real space implementation = 0.27052E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1204 z1= 1 -.352336997520311E-02 0.000000000000000E+00 z1= 2 0.331412281224618E-03 0.000000000000000E+00 z1= 3 0.199369218520487E-02 0.000000000000000E+00 alpha(00001204)=0.000000000000000E+00 beta (00001205)=0.131102418722573E+02 gamma(00001205)=0.131102418722573E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.37254E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1205 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001205)=0.000000000000000E+00 beta (00001206)=0.134189796093844E+02 gamma(00001206)=0.134189796093844E+02 lr_calc_dens: Charge drift due to real space implementation = -0.28037E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1206 z1= 1 0.377856659174912E-02 0.000000000000000E+00 z1= 2 -.317877750926138E-03 0.000000000000000E+00 z1= 3 -.195480738154696E-02 0.000000000000000E+00 alpha(00001206)=0.000000000000000E+00 beta (00001207)=0.129412200432118E+02 gamma(00001207)=0.129412200432118E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.37344E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1207 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001207)=0.000000000000000E+00 beta (00001208)=0.134214364074117E+02 gamma(00001208)=0.134214364074117E+02 lr_calc_dens: Charge drift due to real space implementation = 0.28475E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1208 z1= 1 -.390940046077149E-02 0.000000000000000E+00 z1= 2 0.296229556377085E-03 0.000000000000000E+00 z1= 3 0.188785395149980E-02 0.000000000000000E+00 alpha(00001208)=0.000000000000000E+00 beta (00001209)=0.131114554019475E+02 gamma(00001209)=0.131114554019475E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.37074E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1209 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001209)=0.000000000000000E+00 beta (00001210)=0.134000777749864E+02 gamma(00001210)=0.134000777749864E+02 lr_calc_dens: Charge drift due to real space implementation = -0.30263E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1210 z1= 1 0.391909997765413E-02 0.000000000000000E+00 z1= 2 -.277697985569120E-03 0.000000000000000E+00 z1= 3 -.184954273959886E-02 0.000000000000000E+00 alpha(00001210)=0.000000000000000E+00 beta (00001211)=0.130424444270844E+02 gamma(00001211)=0.130424444270844E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.34864E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1211 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001211)=0.000000000000000E+00 beta (00001212)=0.134612878875464E+02 gamma(00001212)=0.134612878875464E+02 lr_calc_dens: Charge drift due to real space implementation = 0.29790E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1212 z1= 1 -.371333878842833E-02 0.000000000000000E+00 z1= 2 0.258115672297757E-03 0.000000000000000E+00 z1= 3 0.179008635745691E-02 0.000000000000000E+00 alpha(00001212)=0.000000000000000E+00 beta (00001213)=0.129475805273116E+02 gamma(00001213)=0.129475805273116E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.33590E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1213 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001213)=0.000000000000000E+00 beta (00001214)=0.134726609187419E+02 gamma(00001214)=0.134726609187419E+02 lr_calc_dens: Charge drift due to real space implementation = -0.28777E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1214 z1= 1 0.322620182190726E-02 0.000000000000000E+00 z1= 2 -.234016712077378E-03 0.000000000000000E+00 z1= 3 -.171773834453540E-02 0.000000000000000E+00 alpha(00001214)=0.000000000000000E+00 beta (00001215)=0.130231304131171E+02 gamma(00001215)=0.130231304131171E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.31980E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1215 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001215)=0.000000000000000E+00 beta (00001216)=0.135069668545101E+02 gamma(00001216)=0.135069668545101E+02 lr_calc_dens: Charge drift due to real space implementation = 0.26534E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1216 z1= 1 -.262740850683076E-02 0.000000000000000E+00 z1= 2 0.212636703439751E-03 0.000000000000000E+00 z1= 3 0.164965490813477E-02 0.000000000000000E+00 alpha(00001216)=0.000000000000000E+00 beta (00001217)=0.130675960851520E+02 gamma(00001217)=0.130675960851520E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.32172E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1217 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001217)=0.000000000000000E+00 beta (00001218)=0.134397439189372E+02 gamma(00001218)=0.134397439189372E+02 lr_calc_dens: Charge drift due to real space implementation = -0.25489E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1218 z1= 1 0.216123652380481E-02 0.000000000000000E+00 z1= 2 -.191340106750703E-03 0.000000000000000E+00 z1= 3 -.159803127177641E-02 0.000000000000000E+00 alpha(00001218)=0.000000000000000E+00 beta (00001219)=0.131073319126792E+02 gamma(00001219)=0.131073319126792E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.32601E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1219 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001219)=0.000000000000000E+00 beta (00001220)=0.135232796072998E+02 gamma(00001220)=0.135232796072998E+02 lr_calc_dens: Charge drift due to real space implementation = 0.25421E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1220 z1= 1 -.191255015310307E-02 0.000000000000000E+00 z1= 2 0.172000018430047E-03 0.000000000000000E+00 z1= 3 0.153883066656947E-02 0.000000000000000E+00 alpha(00001220)=0.000000000000000E+00 beta (00001221)=0.130542347601435E+02 gamma(00001221)=0.130542347601435E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.33301E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1221 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001221)=0.000000000000000E+00 beta (00001222)=0.133752356108963E+02 gamma(00001222)=0.133752356108963E+02 lr_calc_dens: Charge drift due to real space implementation = -0.26447E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1222 z1= 1 0.196129369900297E-02 0.000000000000000E+00 z1= 2 -.149311316439362E-03 0.000000000000000E+00 z1= 3 -.149242464870192E-02 0.000000000000000E+00 alpha(00001222)=0.000000000000000E+00 beta (00001223)=0.131224282678792E+02 gamma(00001223)=0.131224282678792E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.32741E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1223 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001223)=0.000000000000000E+00 beta (00001224)=0.134130603129974E+02 gamma(00001224)=0.134130603129974E+02 lr_calc_dens: Charge drift due to real space implementation = 0.27765E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1224 z1= 1 -.223599239945951E-02 0.000000000000000E+00 z1= 2 0.132004443701051E-03 0.000000000000000E+00 z1= 3 0.144621545073850E-02 0.000000000000000E+00 alpha(00001224)=0.000000000000000E+00 beta (00001225)=0.130567025656010E+02 gamma(00001225)=0.130567025656010E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.31220E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1225 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001225)=0.000000000000000E+00 beta (00001226)=0.134237660432193E+02 gamma(00001226)=0.134237660432193E+02 lr_calc_dens: Charge drift due to real space implementation = -0.27402E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1226 z1= 1 0.249209938482671E-02 0.000000000000000E+00 z1= 2 -.107351075177537E-03 0.000000000000000E+00 z1= 3 -.139362774911536E-02 0.000000000000000E+00 alpha(00001226)=0.000000000000000E+00 beta (00001227)=0.132043893774538E+02 gamma(00001227)=0.132043893774538E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.30179E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1227 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001227)=0.000000000000000E+00 beta (00001228)=0.134302086513390E+02 gamma(00001228)=0.134302086513390E+02 lr_calc_dens: Charge drift due to real space implementation = 0.27594E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1228 z1= 1 -.266765080934574E-02 0.000000000000000E+00 z1= 2 0.865378141324865E-04 0.000000000000000E+00 z1= 3 0.135121457668482E-02 0.000000000000000E+00 alpha(00001228)=0.000000000000000E+00 beta (00001229)=0.130740746918665E+02 gamma(00001229)=0.130740746918665E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.29549E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1229 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001229)=0.000000000000000E+00 beta (00001230)=0.134947379356864E+02 gamma(00001230)=0.134947379356864E+02 lr_calc_dens: Charge drift due to real space implementation = -0.28062E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1230 z1= 1 0.271954575360179E-02 0.000000000000000E+00 z1= 2 -.608577344277119E-04 0.000000000000000E+00 z1= 3 -.128988059866927E-02 0.000000000000000E+00 alpha(00001230)=0.000000000000000E+00 beta (00001231)=0.130396700375504E+02 gamma(00001231)=0.130396700375504E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.27869E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1231 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001231)=0.000000000000000E+00 beta (00001232)=0.135533567940953E+02 gamma(00001232)=0.135533567940953E+02 lr_calc_dens: Charge drift due to real space implementation = 0.27395E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1232 z1= 1 -.260824259991401E-02 0.000000000000000E+00 z1= 2 0.420298916256490E-04 0.000000000000000E+00 z1= 3 0.121591235427354E-02 0.000000000000000E+00 alpha(00001232)=0.000000000000000E+00 beta (00001233)=0.130947860578031E+02 gamma(00001233)=0.130947860578031E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.25696E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1233 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001233)=0.000000000000000E+00 beta (00001234)=0.135289104260091E+02 gamma(00001234)=0.135289104260091E+02 lr_calc_dens: Charge drift due to real space implementation = -0.24931E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1234 z1= 1 0.255715107501091E-02 0.000000000000000E+00 z1= 2 -.179296090357063E-04 0.000000000000000E+00 z1= 3 -.115301278363273E-02 0.000000000000000E+00 alpha(00001234)=0.000000000000000E+00 beta (00001235)=0.131095489439261E+02 gamma(00001235)=0.131095489439261E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.25871E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1235 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001235)=0.000000000000000E+00 beta (00001236)=0.134887798341120E+02 gamma(00001236)=0.134887798341120E+02 lr_calc_dens: Charge drift due to real space implementation = 0.24002E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1236 z1= 1 -.271714860714949E-02 0.000000000000000E+00 z1= 2 -.352744382007848E-05 0.000000000000000E+00 z1= 3 0.109191882541657E-02 0.000000000000000E+00 alpha(00001236)=0.000000000000000E+00 beta (00001237)=0.130156947833061E+02 gamma(00001237)=0.130156947833061E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.26798E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1237 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001237)=0.000000000000000E+00 beta (00001238)=0.134563887607775E+02 gamma(00001238)=0.134563887607775E+02 lr_calc_dens: Charge drift due to real space implementation = -0.24517E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1238 z1= 1 0.294946807274164E-02 0.000000000000000E+00 z1= 2 0.276487599061613E-04 0.000000000000000E+00 z1= 3 -.102869758753488E-02 0.000000000000000E+00 alpha(00001238)=0.000000000000000E+00 beta (00001239)=0.130183532746054E+02 gamma(00001239)=0.130183532746054E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.26267E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1239 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001239)=0.000000000000000E+00 beta (00001240)=0.134564824725442E+02 gamma(00001240)=0.134564824725442E+02 lr_calc_dens: Charge drift due to real space implementation = 0.24194E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1240 z1= 1 -.323145610187048E-02 0.000000000000000E+00 z1= 2 -.504410240385277E-04 0.000000000000000E+00 z1= 3 0.963266612526399E-03 0.000000000000000E+00 alpha(00001240)=0.000000000000000E+00 beta (00001241)=0.130332735989594E+02 gamma(00001241)=0.130332735989594E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.26352E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1241 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001241)=0.000000000000000E+00 beta (00001242)=0.134772602241299E+02 gamma(00001242)=0.134772602241299E+02 lr_calc_dens: Charge drift due to real space implementation = -0.24444E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1242 z1= 1 0.349826488600120E-02 0.000000000000000E+00 z1= 2 0.760112985178528E-04 0.000000000000000E+00 z1= 3 -.899190550231041E-03 0.000000000000000E+00 alpha(00001242)=0.000000000000000E+00 beta (00001243)=0.130457424393598E+02 gamma(00001243)=0.130457424393598E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.26321E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1243 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001243)=0.000000000000000E+00 beta (00001244)=0.134209635396902E+02 gamma(00001244)=0.134209635396902E+02 lr_calc_dens: Charge drift due to real space implementation = 0.25371E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1244 z1= 1 -.373343364933305E-02 0.000000000000000E+00 z1= 2 -.984427123269984E-04 0.000000000000000E+00 z1= 3 0.836853586968256E-03 0.000000000000000E+00 alpha(00001244)=0.000000000000000E+00 beta (00001245)=0.129874299445038E+02 gamma(00001245)=0.129874299445038E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.25085E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1245 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001245)=0.000000000000000E+00 beta (00001246)=0.135156123575523E+02 gamma(00001246)=0.135156123575523E+02 lr_calc_dens: Charge drift due to real space implementation = -0.25097E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1246 z1= 1 0.387358305807323E-02 0.000000000000000E+00 z1= 2 0.121665733151073E-03 0.000000000000000E+00 z1= 3 -.766532565624429E-03 0.000000000000000E+00 alpha(00001246)=0.000000000000000E+00 beta (00001247)=0.129592525747248E+02 gamma(00001247)=0.129592525747248E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.23586E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1247 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001247)=0.000000000000000E+00 beta (00001248)=0.135522328173999E+02 gamma(00001248)=0.135522328173999E+02 lr_calc_dens: Charge drift due to real space implementation = 0.23299E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1248 z1= 1 -.393527052014255E-02 0.000000000000000E+00 z1= 2 -.144027608131585E-03 0.000000000000000E+00 z1= 3 0.690860796382958E-03 0.000000000000000E+00 alpha(00001248)=0.000000000000000E+00 beta (00001249)=0.129930188488836E+02 gamma(00001249)=0.129930188488836E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.23417E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1249 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001249)=0.000000000000000E+00 beta (00001250)=0.135167241881443E+02 gamma(00001250)=0.135167241881443E+02 lr_calc_dens: Charge drift due to real space implementation = -0.22381E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1250 z1= 1 0.399963085607033E-02 0.000000000000000E+00 z1= 2 0.163252668681294E-03 0.000000000000000E+00 z1= 3 -.620113497734777E-03 0.000000000000000E+00 alpha(00001250)=0.000000000000000E+00 beta (00001251)=0.129324654248531E+02 gamma(00001251)=0.129324654248531E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.23270E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1251 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001251)=0.000000000000000E+00 beta (00001252)=0.135099009285154E+02 gamma(00001252)=0.135099009285154E+02 lr_calc_dens: Charge drift due to real space implementation = 0.21606E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1252 z1= 1 -.404486747614670E-02 0.000000000000000E+00 z1= 2 -.186954099073233E-03 0.000000000000000E+00 z1= 3 0.544999106125898E-03 0.000000000000000E+00 alpha(00001252)=0.000000000000000E+00 beta (00001253)=0.130005365063010E+02 gamma(00001253)=0.130005365063010E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.23369E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1253 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001253)=0.000000000000000E+00 beta (00001254)=0.134923015860583E+02 gamma(00001254)=0.134923015860583E+02 lr_calc_dens: Charge drift due to real space implementation = -0.21498E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1254 z1= 1 0.422050721158890E-02 0.000000000000000E+00 z1= 2 0.208771307631065E-03 0.000000000000000E+00 z1= 3 -.474863497477375E-03 0.000000000000000E+00 alpha(00001254)=0.000000000000000E+00 beta (00001255)=0.130073933181121E+02 gamma(00001255)=0.130073933181121E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.23718E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1255 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001255)=0.000000000000000E+00 beta (00001256)=0.135204778037934E+02 gamma(00001256)=0.135204778037934E+02 lr_calc_dens: Charge drift due to real space implementation = 0.22548E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1256 z1= 1 -.448453828183336E-02 0.000000000000000E+00 z1= 2 -.233466425297236E-03 0.000000000000000E+00 z1= 3 0.403159992489550E-03 0.000000000000000E+00 alpha(00001256)=0.000000000000000E+00 beta (00001257)=0.130832162955278E+02 gamma(00001257)=0.130832162955278E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.22409E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1257 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001257)=0.000000000000000E+00 beta (00001258)=0.134340642181568E+02 gamma(00001258)=0.134340642181568E+02 lr_calc_dens: Charge drift due to real space implementation = -0.22972E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1258 z1= 1 0.482870303391997E-02 0.000000000000000E+00 z1= 2 0.256276994555538E-03 0.000000000000000E+00 z1= 3 -.336844742639473E-03 0.000000000000000E+00 alpha(00001258)=0.000000000000000E+00 beta (00001259)=0.130470241162072E+02 gamma(00001259)=0.130470241162072E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.20281E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1259 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001259)=0.000000000000000E+00 beta (00001260)=0.135495079884862E+02 gamma(00001260)=0.135495079884862E+02 lr_calc_dens: Charge drift due to real space implementation = 0.21063E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1260 z1= 1 -.507678130573831E-02 0.000000000000000E+00 z1= 2 -.285847926225742E-03 0.000000000000000E+00 z1= 3 0.265618550862850E-03 0.000000000000000E+00 alpha(00001260)=0.000000000000000E+00 beta (00001261)=0.131154447849465E+02 gamma(00001261)=0.131154447849465E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.20011E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1261 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001261)=0.000000000000000E+00 beta (00001262)=0.134727063613567E+02 gamma(00001262)=0.134727063613567E+02 lr_calc_dens: Charge drift due to real space implementation = -0.19600E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1262 z1= 1 0.513314216623057E-02 0.000000000000000E+00 z1= 2 0.311012195082788E-03 0.000000000000000E+00 z1= 3 -.197424537589542E-03 0.000000000000000E+00 alpha(00001262)=0.000000000000000E+00 beta (00001263)=0.129941780563103E+02 gamma(00001263)=0.129941780563103E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.21341E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1263 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001263)=0.000000000000000E+00 beta (00001264)=0.134289506294637E+02 gamma(00001264)=0.134289506294637E+02 lr_calc_dens: Charge drift due to real space implementation = 0.20231E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1264 z1= 1 -.499721206247943E-02 0.000000000000000E+00 z1= 2 -.339666711220090E-03 0.000000000000000E+00 z1= 3 0.127304066785809E-03 0.000000000000000E+00 alpha(00001264)=0.000000000000000E+00 beta (00001265)=0.129565290630599E+02 gamma(00001265)=0.129565290630599E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.20970E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1265 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001265)=0.000000000000000E+00 beta (00001266)=0.135033118897786E+02 gamma(00001266)=0.135033118897786E+02 lr_calc_dens: Charge drift due to real space implementation = -0.20306E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1266 z1= 1 0.493808690391164E-02 0.000000000000000E+00 z1= 2 0.361250114639208E-03 0.000000000000000E+00 z1= 3 -.559281759619549E-04 0.000000000000000E+00 alpha(00001266)=0.000000000000000E+00 beta (00001267)=0.130082299057627E+02 gamma(00001267)=0.130082299057627E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.20057E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1267 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001267)=0.000000000000000E+00 beta (00001268)=0.134676279683545E+02 gamma(00001268)=0.134676279683545E+02 lr_calc_dens: Charge drift due to real space implementation = 0.20202E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1268 z1= 1 -.497082311503090E-02 0.000000000000000E+00 z1= 2 -.386979870688861E-03 0.000000000000000E+00 z1= 3 -.156920333032420E-04 0.000000000000000E+00 alpha(00001268)=0.000000000000000E+00 beta (00001269)=0.130254670232536E+02 gamma(00001269)=0.130254670232536E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.18358E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1269 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001269)=0.000000000000000E+00 beta (00001270)=0.134519077334232E+02 gamma(00001270)=0.134519077334232E+02 lr_calc_dens: Charge drift due to real space implementation = -0.18574E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1270 z1= 1 0.508418843874095E-02 0.000000000000000E+00 z1= 2 0.411748089960187E-03 0.000000000000000E+00 z1= 3 0.884167544720181E-04 0.000000000000000E+00 alpha(00001270)=0.000000000000000E+00 beta (00001271)=0.130642438176664E+02 gamma(00001271)=0.130642438176664E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.18290E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1271 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001271)=0.000000000000000E+00 beta (00001272)=0.134822811754488E+02 gamma(00001272)=0.134822811754488E+02 lr_calc_dens: Charge drift due to real space implementation = 0.17565E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1272 z1= 1 -.525059849124222E-02 0.000000000000000E+00 z1= 2 -.439727349009370E-03 0.000000000000000E+00 z1= 3 -.160566894009708E-03 0.000000000000000E+00 alpha(00001272)=0.000000000000000E+00 beta (00001273)=0.129937113872255E+02 gamma(00001273)=0.129937113872255E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.19291E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1273 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001273)=0.000000000000000E+00 beta (00001274)=0.134613976509962E+02 gamma(00001274)=0.134613976509962E+02 lr_calc_dens: Charge drift due to real space implementation = -0.17822E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1274 z1= 1 0.539832638551435E-02 0.000000000000000E+00 z1= 2 0.466164768903306E-03 0.000000000000000E+00 z1= 3 0.232663359005391E-03 0.000000000000000E+00 alpha(00001274)=0.000000000000000E+00 beta (00001275)=0.130606833573107E+02 gamma(00001275)=0.130606833573107E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.19903E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1275 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001275)=0.000000000000000E+00 beta (00001276)=0.135349314495552E+02 gamma(00001276)=0.135349314495552E+02 lr_calc_dens: Charge drift due to real space implementation = 0.19139E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1276 z1= 1 -.553452485052904E-02 0.000000000000000E+00 z1= 2 -.494489682504736E-03 0.000000000000000E+00 z1= 3 -.301583619432714E-03 0.000000000000000E+00 alpha(00001276)=0.000000000000000E+00 beta (00001277)=0.130411382266709E+02 gamma(00001277)=0.130411382266709E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.18735E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1277 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001277)=0.000000000000000E+00 beta (00001278)=0.135012880375209E+02 gamma(00001278)=0.135012880375209E+02 lr_calc_dens: Charge drift due to real space implementation = -0.19045E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1278 z1= 1 0.557814890385959E-02 0.000000000000000E+00 z1= 2 0.522321623470380E-03 0.000000000000000E+00 z1= 3 0.370599954329789E-03 0.000000000000000E+00 alpha(00001278)=0.000000000000000E+00 beta (00001279)=0.131790921165511E+02 gamma(00001279)=0.131790921165511E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.17675E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1279 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001279)=0.000000000000000E+00 beta (00001280)=0.134549033791388E+02 gamma(00001280)=0.134549033791388E+02 lr_calc_dens: Charge drift due to real space implementation = 0.18952E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1280 z1= 1 -.569007334748641E-02 0.000000000000000E+00 z1= 2 -.555865929788941E-03 0.000000000000000E+00 z1= 3 -.442088563620704E-03 0.000000000000000E+00 alpha(00001280)=0.000000000000000E+00 beta (00001281)=0.130278003400031E+02 gamma(00001281)=0.130278003400031E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.17095E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1281 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001281)=0.000000000000000E+00 beta (00001282)=0.134884088609141E+02 gamma(00001282)=0.134884088609141E+02 lr_calc_dens: Charge drift due to real space implementation = -0.19166E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1282 z1= 1 0.574643356341125E-02 0.000000000000000E+00 z1= 2 0.577058985121119E-03 0.000000000000000E+00 z1= 3 0.508933330052754E-03 0.000000000000000E+00 alpha(00001282)=0.000000000000000E+00 beta (00001283)=0.130197100245332E+02 gamma(00001283)=0.130197100245332E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.15488E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1283 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001283)=0.000000000000000E+00 beta (00001284)=0.134786734815042E+02 gamma(00001284)=0.134786734815042E+02 lr_calc_dens: Charge drift due to real space implementation = 0.18255E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1284 z1= 1 -.585483885202891E-02 0.000000000000000E+00 z1= 2 -.604170723871456E-03 0.000000000000000E+00 z1= 3 -.574371978934094E-03 0.000000000000000E+00 alpha(00001284)=0.000000000000000E+00 beta (00001285)=0.130411219528641E+02 gamma(00001285)=0.130411219528641E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.14321E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1285 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001285)=0.000000000000000E+00 beta (00001286)=0.135728664969126E+02 gamma(00001286)=0.135728664969126E+02 lr_calc_dens: Charge drift due to real space implementation = -0.17015E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1286 z1= 1 0.598372798877491E-02 0.000000000000000E+00 z1= 2 0.624835519980110E-03 0.000000000000000E+00 z1= 3 0.636839501162918E-03 0.000000000000000E+00 alpha(00001286)=0.000000000000000E+00 beta (00001287)=0.130088765572699E+02 gamma(00001287)=0.130088765572699E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14000E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1287 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001287)=0.000000000000000E+00 beta (00001288)=0.134795272347426E+02 gamma(00001288)=0.134795272347426E+02 lr_calc_dens: Charge drift due to real space implementation = 0.16248E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1288 z1= 1 -.620334631958037E-02 0.000000000000000E+00 z1= 2 -.650391538432225E-03 0.000000000000000E+00 z1= 3 -.701446432054407E-03 0.000000000000000E+00 alpha(00001288)=0.000000000000000E+00 beta (00001289)=0.130133194044728E+02 gamma(00001289)=0.130133194044728E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.13664E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1289 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001289)=0.000000000000000E+00 beta (00001290)=0.135250315065039E+02 gamma(00001290)=0.135250315065039E+02 lr_calc_dens: Charge drift due to real space implementation = -0.14969E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1290 z1= 1 0.643407033550301E-02 0.000000000000000E+00 z1= 2 0.672724941718987E-03 0.000000000000000E+00 z1= 3 0.766147856357012E-03 0.000000000000000E+00 alpha(00001290)=0.000000000000000E+00 beta (00001291)=0.129477551249705E+02 gamma(00001291)=0.129477551249705E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.15168E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1291 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001291)=0.000000000000000E+00 beta (00001292)=0.135525946931954E+02 gamma(00001292)=0.135525946931954E+02 lr_calc_dens: Charge drift due to real space implementation = 0.15846E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1292 z1= 1 -.646017770663349E-02 0.000000000000000E+00 z1= 2 -.692098550916940E-03 0.000000000000000E+00 z1= 3 -.826377099118795E-03 0.000000000000000E+00 alpha(00001292)=0.000000000000000E+00 beta (00001293)=0.129816707357444E+02 gamma(00001293)=0.129816707357444E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.14923E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1293 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001293)=0.000000000000000E+00 beta (00001294)=0.135364425290850E+02 gamma(00001294)=0.135364425290850E+02 lr_calc_dens: Charge drift due to real space implementation = -0.16444E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1294 z1= 1 0.641309941950509E-02 0.000000000000000E+00 z1= 2 0.712326986204040E-03 0.000000000000000E+00 z1= 3 0.892513701472340E-03 0.000000000000000E+00 alpha(00001294)=0.000000000000000E+00 beta (00001295)=0.129705077850962E+02 gamma(00001295)=0.129705077850962E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13490E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1295 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001295)=0.000000000000000E+00 beta (00001296)=0.135247725239067E+02 gamma(00001296)=0.135247725239067E+02 lr_calc_dens: Charge drift due to real space implementation = 0.15661E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1296 z1= 1 -.634304720725566E-02 0.000000000000000E+00 z1= 2 -.736350653209816E-03 0.000000000000000E+00 z1= 3 -.957660732038802E-03 0.000000000000000E+00 alpha(00001296)=0.000000000000000E+00 beta (00001297)=0.129677780804895E+02 gamma(00001297)=0.129677780804895E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12392E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1297 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001297)=0.000000000000000E+00 beta (00001298)=0.134824927812563E+02 gamma(00001298)=0.134824927812563E+02 lr_calc_dens: Charge drift due to real space implementation = -0.14152E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1298 z1= 1 0.629678812343904E-02 0.000000000000000E+00 z1= 2 0.760166417698984E-03 0.000000000000000E+00 z1= 3 0.102697057383206E-02 0.000000000000000E+00 alpha(00001298)=0.000000000000000E+00 beta (00001299)=0.130117697950671E+02 gamma(00001299)=0.130117697950671E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12208E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1299 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001299)=0.000000000000000E+00 beta (00001300)=0.135058026234129E+02 gamma(00001300)=0.135058026234129E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12554E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1300 z1= 1 -.625711336692664E-02 0.000000000000000E+00 z1= 2 -.785571985370370E-03 0.000000000000000E+00 z1= 3 -.109587626910204E-02 0.000000000000000E+00 alpha(00001300)=0.000000000000000E+00 beta (00001301)=0.130024675871729E+02 gamma(00001301)=0.130024675871729E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.13790E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1301 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001301)=0.000000000000000E+00 beta (00001302)=0.134776957205206E+02 gamma(00001302)=0.134776957205206E+02 lr_calc_dens: Charge drift due to real space implementation = -0.13526E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1302 z1= 1 0.614302953633514E-02 0.000000000000000E+00 z1= 2 0.810782240968201E-03 0.000000000000000E+00 z1= 3 0.116664081936774E-02 0.000000000000000E+00 alpha(00001302)=0.000000000000000E+00 beta (00001303)=0.129210898047853E+02 gamma(00001303)=0.129210898047853E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13986E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1303 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001303)=0.000000000000000E+00 beta (00001304)=0.135158602320984E+02 gamma(00001304)=0.135158602320984E+02 lr_calc_dens: Charge drift due to real space implementation = 0.14875E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1304 z1= 1 -.594791348355164E-02 0.000000000000000E+00 z1= 2 -.832423299599304E-03 0.000000000000000E+00 z1= 3 -.122543729378360E-02 0.000000000000000E+00 alpha(00001304)=0.000000000000000E+00 beta (00001305)=0.129786362860866E+02 gamma(00001305)=0.129786362860866E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12317E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1305 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001305)=0.000000000000000E+00 beta (00001306)=0.134893198319546E+02 gamma(00001306)=0.134893198319546E+02 lr_calc_dens: Charge drift due to real space implementation = -0.14614E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1306 z1= 1 0.580078426847291E-02 0.000000000000000E+00 z1= 2 0.858668522007859E-03 0.000000000000000E+00 z1= 3 0.129387338762691E-02 0.000000000000000E+00 alpha(00001306)=0.000000000000000E+00 beta (00001307)=0.130000551272829E+02 gamma(00001307)=0.130000551272829E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10788E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1307 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001307)=0.000000000000000E+00 beta (00001308)=0.134865283484744E+02 gamma(00001308)=0.134865283484744E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12990E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1308 z1= 1 -.559726255455447E-02 0.000000000000000E+00 z1= 2 -.888350988237068E-03 0.000000000000000E+00 z1= 3 -.136352127427804E-02 0.000000000000000E+00 alpha(00001308)=0.000000000000000E+00 beta (00001309)=0.130089388629804E+02 gamma(00001309)=0.130089388629804E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10829E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1309 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001309)=0.000000000000000E+00 beta (00001310)=0.134970103662782E+02 gamma(00001310)=0.134970103662782E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12003E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1310 z1= 1 0.522609673507843E-02 0.000000000000000E+00 z1= 2 0.912830258649302E-03 0.000000000000000E+00 z1= 3 0.143440837619047E-02 0.000000000000000E+00 alpha(00001310)=0.000000000000000E+00 beta (00001311)=0.130345190405555E+02 gamma(00001311)=0.130345190405555E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.11419E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1311 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001311)=0.000000000000000E+00 beta (00001312)=0.134500732475557E+02 gamma(00001312)=0.134500732475557E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11843E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1312 z1= 1 -.473565938234914E-02 0.000000000000000E+00 z1= 2 -.940201440876770E-03 0.000000000000000E+00 z1= 3 -.151213033468894E-02 0.000000000000000E+00 alpha(00001312)=0.000000000000000E+00 beta (00001313)=0.129799217085417E+02 gamma(00001313)=0.129799217085417E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11876E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1313 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001313)=0.000000000000000E+00 beta (00001314)=0.134721731757263E+02 gamma(00001314)=0.134721731757263E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12335E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1314 z1= 1 0.419636277492185E-02 0.000000000000000E+00 z1= 2 0.964539671786967E-03 0.000000000000000E+00 z1= 3 0.158320862354850E-02 0.000000000000000E+00 alpha(00001314)=0.000000000000000E+00 beta (00001315)=0.130723098874236E+02 gamma(00001315)=0.130723098874236E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.11410E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1315 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001315)=0.000000000000000E+00 beta (00001316)=0.135611619391558E+02 gamma(00001316)=0.135611619391558E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12759E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1316 z1= 1 -.373321415496727E-02 0.000000000000000E+00 z1= 2 -.989688758067524E-03 0.000000000000000E+00 z1= 3 -.165175181340105E-02 0.000000000000000E+00 alpha(00001316)=0.000000000000000E+00 beta (00001317)=0.129893663813799E+02 gamma(00001317)=0.129893663813799E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10103E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1317 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001317)=0.000000000000000E+00 beta (00001318)=0.134910636637885E+02 gamma(00001318)=0.134910636637885E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11705E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1318 z1= 1 0.338417361737052E-02 0.000000000000000E+00 z1= 2 0.101797655974317E-02 0.000000000000000E+00 z1= 3 0.172118078112743E-02 0.000000000000000E+00 alpha(00001318)=0.000000000000000E+00 beta (00001319)=0.129353024126343E+02 gamma(00001319)=0.129353024126343E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10302E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1319 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001319)=0.000000000000000E+00 beta (00001320)=0.136144595330324E+02 gamma(00001320)=0.136144595330324E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11578E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1320 z1= 1 -.315908443579508E-02 0.000000000000000E+00 z1= 2 -.103048658428475E-02 0.000000000000000E+00 z1= 3 -.176688391644657E-02 0.000000000000000E+00 alpha(00001320)=0.000000000000000E+00 beta (00001321)=0.130105258009769E+02 gamma(00001321)=0.130105258009769E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10214E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1321 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001321)=0.000000000000000E+00 beta (00001322)=0.135707871747329E+02 gamma(00001322)=0.135707871747329E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11866E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1322 z1= 1 0.304708369446156E-02 0.000000000000000E+00 z1= 2 0.105389304150263E-02 0.000000000000000E+00 z1= 3 0.183186195037712E-02 0.000000000000000E+00 alpha(00001322)=0.000000000000000E+00 beta (00001323)=0.129317573181047E+02 gamma(00001323)=0.129317573181047E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.93123E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1323 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001323)=0.000000000000000E+00 beta (00001324)=0.135099545554067E+02 gamma(00001324)=0.135099545554067E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10918E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1324 z1= 1 -.286978464487760E-02 0.000000000000000E+00 z1= 2 -.107594899218185E-02 0.000000000000000E+00 z1= 3 -.189534732804998E-02 0.000000000000000E+00 alpha(00001324)=0.000000000000000E+00 beta (00001325)=0.129433324883904E+02 gamma(00001325)=0.129433324883904E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.95438E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1325 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001325)=0.000000000000000E+00 beta (00001326)=0.136012144502765E+02 gamma(00001326)=0.136012144502765E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10943E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1326 z1= 1 0.259237222260348E-02 0.000000000000000E+00 z1= 2 0.109368941354868E-02 0.000000000000000E+00 z1= 3 0.195004036535765E-02 0.000000000000000E+00 alpha(00001326)=0.000000000000000E+00 beta (00001327)=0.129695761163793E+02 gamma(00001327)=0.129695761163793E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.91840E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1327 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001327)=0.000000000000000E+00 beta (00001328)=0.134706789536570E+02 gamma(00001328)=0.134706789536570E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11036E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1328 z1= 1 -.232659293144530E-02 0.000000000000000E+00 z1= 2 -.112011174382100E-02 0.000000000000000E+00 z1= 3 -.202924115534385E-02 0.000000000000000E+00 alpha(00001328)=0.000000000000000E+00 beta (00001329)=0.131387280871468E+02 gamma(00001329)=0.131387280871468E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.77908E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1329 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001329)=0.000000000000000E+00 beta (00001330)=0.134442581997519E+02 gamma(00001330)=0.134442581997519E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10219E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1330 z1= 1 0.223488091679426E-02 0.000000000000000E+00 z1= 2 0.116383542759745E-02 0.000000000000000E+00 z1= 3 0.213905188082477E-02 0.000000000000000E+00 alpha(00001330)=0.000000000000000E+00 beta (00001331)=0.130041360963271E+02 gamma(00001331)=0.130041360963271E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.68189E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1331 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001331)=0.000000000000000E+00 beta (00001332)=0.135097525470170E+02 gamma(00001332)=0.135097525470170E+02 lr_calc_dens: Charge drift due to real space implementation = 0.81959E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1332 z1= 1 -.216674635448432E-02 0.000000000000000E+00 z1= 2 -.118916861977109E-02 0.000000000000000E+00 z1= 3 -.221613928311859E-02 0.000000000000000E+00 alpha(00001332)=0.000000000000000E+00 beta (00001333)=0.129892004711920E+02 gamma(00001333)=0.129892004711920E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.79833E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1333 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001333)=0.000000000000000E+00 beta (00001334)=0.135455075031614E+02 gamma(00001334)=0.135455075031614E+02 lr_calc_dens: Charge drift due to real space implementation = -0.76276E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1334 z1= 1 0.207242185235789E-02 0.000000000000000E+00 z1= 2 0.121374902377065E-02 0.000000000000000E+00 z1= 3 0.228652329132644E-02 0.000000000000000E+00 alpha(00001334)=0.000000000000000E+00 beta (00001335)=0.130150545959418E+02 gamma(00001335)=0.130150545959418E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.94380E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1335 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001335)=0.000000000000000E+00 beta (00001336)=0.135023435435908E+02 gamma(00001336)=0.135023435435908E+02 lr_calc_dens: Charge drift due to real space implementation = 0.85038E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1336 z1= 1 -.203504152978807E-02 0.000000000000000E+00 z1= 2 -.123760630874209E-02 0.000000000000000E+00 z1= 3 -.236808762145152E-02 0.000000000000000E+00 alpha(00001336)=0.000000000000000E+00 beta (00001337)=0.130475727281093E+02 gamma(00001337)=0.130475727281093E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.94314E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1337 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001337)=0.000000000000000E+00 beta (00001338)=0.135392975031721E+02 gamma(00001338)=0.135392975031721E+02 lr_calc_dens: Charge drift due to real space implementation = -0.88428E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1338 z1= 1 0.208182400460093E-02 0.000000000000000E+00 z1= 2 0.126897082913359E-02 0.000000000000000E+00 z1= 3 0.244886323718300E-02 0.000000000000000E+00 alpha(00001338)=0.000000000000000E+00 beta (00001339)=0.129566296048332E+02 gamma(00001339)=0.129566296048332E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.91439E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1339 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001339)=0.000000000000000E+00 beta (00001340)=0.134888408908745E+02 gamma(00001340)=0.134888408908745E+02 lr_calc_dens: Charge drift due to real space implementation = 0.82641E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1340 z1= 1 -.221289174293853E-02 0.000000000000000E+00 z1= 2 -.129407582624666E-02 0.000000000000000E+00 z1= 3 -.252215903131080E-02 0.000000000000000E+00 alpha(00001340)=0.000000000000000E+00 beta (00001341)=0.130349672584319E+02 gamma(00001341)=0.130349672584319E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10234E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1341 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001341)=0.000000000000000E+00 beta (00001342)=0.134989818708973E+02 gamma(00001342)=0.134989818708973E+02 lr_calc_dens: Charge drift due to real space implementation = -0.97632E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1342 z1= 1 0.240369090153718E-02 0.000000000000000E+00 z1= 2 0.132781326637118E-02 0.000000000000000E+00 z1= 3 0.260885475256188E-02 0.000000000000000E+00 alpha(00001342)=0.000000000000000E+00 beta (00001343)=0.129961308901374E+02 gamma(00001343)=0.129961308901374E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.98431E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1343 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001343)=0.000000000000000E+00 beta (00001344)=0.135704797231102E+02 gamma(00001344)=0.135704797231102E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11433E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1344 z1= 1 -.256963329198632E-02 0.000000000000000E+00 z1= 2 -.134243372702350E-02 0.000000000000000E+00 z1= 3 -.267383818450018E-02 0.000000000000000E+00 alpha(00001344)=0.000000000000000E+00 beta (00001345)=0.130113963096402E+02 gamma(00001345)=0.130113963096402E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.69103E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1345 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001345)=0.000000000000000E+00 beta (00001346)=0.135858899549509E+02 gamma(00001346)=0.135858899549509E+02 lr_calc_dens: Charge drift due to real space implementation = -0.93967E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1346 z1= 1 0.259629677144948E-02 0.000000000000000E+00 z1= 2 0.136415472931203E-02 0.000000000000000E+00 z1= 3 0.273971440191234E-02 0.000000000000000E+00 alpha(00001346)=0.000000000000000E+00 beta (00001347)=0.130193980352732E+02 gamma(00001347)=0.130193980352732E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.71066E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1347 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001347)=0.000000000000000E+00 beta (00001348)=0.135043458533588E+02 gamma(00001348)=0.135043458533588E+02 lr_calc_dens: Charge drift due to real space implementation = 0.91510E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1348 z1= 1 -.256219552124323E-02 0.000000000000000E+00 z1= 2 -.139178247216160E-02 0.000000000000000E+00 z1= 3 -.282469780036752E-02 0.000000000000000E+00 alpha(00001348)=0.000000000000000E+00 beta (00001349)=0.129387031005594E+02 gamma(00001349)=0.129387031005594E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.68413E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1349 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001349)=0.000000000000000E+00 beta (00001350)=0.135995682282621E+02 gamma(00001350)=0.135995682282621E+02 lr_calc_dens: Charge drift due to real space implementation = -0.95349E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1350 z1= 1 0.249154894222845E-02 0.000000000000000E+00 z1= 2 0.140991794632112E-02 0.000000000000000E+00 z1= 3 0.287377645453042E-02 0.000000000000000E+00 alpha(00001350)=0.000000000000000E+00 beta (00001351)=0.129196731375521E+02 gamma(00001351)=0.129196731375521E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.47418E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1351 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001351)=0.000000000000000E+00 beta (00001352)=0.136544324135569E+02 gamma(00001352)=0.136544324135569E+02 lr_calc_dens: Charge drift due to real space implementation = 0.71172E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1352 z1= 1 -.241128851079841E-02 0.000000000000000E+00 z1= 2 -.141584295378468E-02 0.000000000000000E+00 z1= 3 -.291009754645215E-02 0.000000000000000E+00 alpha(00001352)=0.000000000000000E+00 beta (00001353)=0.129562971963015E+02 gamma(00001353)=0.129562971963015E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.53848E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1353 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001353)=0.000000000000000E+00 beta (00001354)=0.135213630936974E+02 gamma(00001354)=0.135213630936974E+02 lr_calc_dens: Charge drift due to real space implementation = -0.60477E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1354 z1= 1 0.241092650031670E-02 0.000000000000000E+00 z1= 2 0.144282157496945E-02 0.000000000000000E+00 z1= 3 0.298842693766368E-02 0.000000000000000E+00 alpha(00001354)=0.000000000000000E+00 beta (00001355)=0.129787245335814E+02 gamma(00001355)=0.129787245335814E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.69202E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1355 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001355)=0.000000000000000E+00 beta (00001356)=0.135527878155532E+02 gamma(00001356)=0.135527878155532E+02 lr_calc_dens: Charge drift due to real space implementation = 0.70413E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1356 z1= 1 -.248422048191422E-02 0.000000000000000E+00 z1= 2 -.146582719063183E-02 0.000000000000000E+00 z1= 3 -.306653070747486E-02 0.000000000000000E+00 alpha(00001356)=0.000000000000000E+00 beta (00001357)=0.129687729591405E+02 gamma(00001357)=0.129687729591405E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.66792E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1357 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001357)=0.000000000000000E+00 beta (00001358)=0.134753451324947E+02 gamma(00001358)=0.134753451324947E+02 lr_calc_dens: Charge drift due to real space implementation = -0.74569E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1358 z1= 1 0.265803397435747E-02 0.000000000000000E+00 z1= 2 0.150239907370260E-02 0.000000000000000E+00 z1= 3 0.316286768827501E-02 0.000000000000000E+00 alpha(00001358)=0.000000000000000E+00 beta (00001359)=0.130244158884337E+02 gamma(00001359)=0.130244158884337E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.56952E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1359 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001359)=0.000000000000000E+00 beta (00001360)=0.135828455834366E+02 gamma(00001360)=0.135828455834366E+02 lr_calc_dens: Charge drift due to real space implementation = 0.64006E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1360 z1= 1 -.284398759905437E-02 0.000000000000000E+00 z1= 2 -.153288753444816E-02 0.000000000000000E+00 z1= 3 -.324639275445216E-02 0.000000000000000E+00 alpha(00001360)=0.000000000000000E+00 beta (00001361)=0.130255711380821E+02 gamma(00001361)=0.130255711380821E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.61846E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1361 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001361)=0.000000000000000E+00 beta (00001362)=0.135748498450670E+02 gamma(00001362)=0.135748498450670E+02 lr_calc_dens: Charge drift due to real space implementation = -0.60522E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1362 z1= 1 0.308037550461456E-02 0.000000000000000E+00 z1= 2 0.156428072671982E-02 0.000000000000000E+00 z1= 3 0.333327066761889E-02 0.000000000000000E+00 alpha(00001362)=0.000000000000000E+00 beta (00001363)=0.129739357924903E+02 gamma(00001363)=0.129739357924903E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.71229E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1363 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001363)=0.000000000000000E+00 beta (00001364)=0.135004182045008E+02 gamma(00001364)=0.135004182045008E+02 lr_calc_dens: Charge drift due to real space implementation = 0.69811E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1364 z1= 1 -.339480567621489E-02 0.000000000000000E+00 z1= 2 -.160022858439897E-02 0.000000000000000E+00 z1= 3 -.342925509608359E-02 0.000000000000000E+00 alpha(00001364)=0.000000000000000E+00 beta (00001365)=0.128859012594880E+02 gamma(00001365)=0.128859012594880E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.65955E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1365 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001365)=0.000000000000000E+00 beta (00001366)=0.134551172514351E+02 gamma(00001366)=0.134551172514351E+02 lr_calc_dens: Charge drift due to real space implementation = -0.71815E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1366 z1= 1 0.359615265522864E-02 0.000000000000000E+00 z1= 2 0.163217346279571E-02 0.000000000000000E+00 z1= 3 0.351718113302290E-02 0.000000000000000E+00 alpha(00001366)=0.000000000000000E+00 beta (00001367)=0.129959466804938E+02 gamma(00001367)=0.129959466804938E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.54645E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1367 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001367)=0.000000000000000E+00 beta (00001368)=0.135585743131478E+02 gamma(00001368)=0.135585743131478E+02 lr_calc_dens: Charge drift due to real space implementation = 0.60895E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1368 z1= 1 -.358372057546709E-02 0.000000000000000E+00 z1= 2 -.166214838677211E-02 0.000000000000000E+00 z1= 3 -.360721404940879E-02 0.000000000000000E+00 alpha(00001368)=0.000000000000000E+00 beta (00001369)=0.128851179948538E+02 gamma(00001369)=0.128851179948538E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.59530E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1369 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001369)=0.000000000000000E+00 beta (00001370)=0.135187062135197E+02 gamma(00001370)=0.135187062135197E+02 lr_calc_dens: Charge drift due to real space implementation = -0.61200E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1370 z1= 1 0.336585820304151E-02 0.000000000000000E+00 z1= 2 0.168305645777851E-02 0.000000000000000E+00 z1= 3 0.368136317419684E-02 0.000000000000000E+00 alpha(00001370)=0.000000000000000E+00 beta (00001371)=0.129427318176923E+02 gamma(00001371)=0.129427318176923E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.59918E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1371 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001371)=0.000000000000000E+00 beta (00001372)=0.134889868463506E+02 gamma(00001372)=0.134889868463506E+02 lr_calc_dens: Charge drift due to real space implementation = 0.66904E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1372 z1= 1 -.306928178031834E-02 0.000000000000000E+00 z1= 2 -.172149215711397E-02 0.000000000000000E+00 z1= 3 -.378222739450010E-02 0.000000000000000E+00 alpha(00001372)=0.000000000000000E+00 beta (00001373)=0.129552028518191E+02 gamma(00001373)=0.129552028518191E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.43710E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1373 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001373)=0.000000000000000E+00 beta (00001374)=0.135690410063377E+02 gamma(00001374)=0.135690410063377E+02 lr_calc_dens: Charge drift due to real space implementation = -0.46583E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1374 z1= 1 0.274379817287111E-02 0.000000000000000E+00 z1= 2 0.174730743912444E-02 0.000000000000000E+00 z1= 3 0.386303612472516E-02 0.000000000000000E+00 alpha(00001374)=0.000000000000000E+00 beta (00001375)=0.129230922653950E+02 gamma(00001375)=0.129230922653950E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.54882E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1375 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001375)=0.000000000000000E+00 beta (00001376)=0.135775241959277E+02 gamma(00001376)=0.135775241959277E+02 lr_calc_dens: Charge drift due to real space implementation = 0.41066E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1376 z1= 1 -.241971294487960E-02 0.000000000000000E+00 z1= 2 -.177210601486491E-02 0.000000000000000E+00 z1= 3 -.393677883668991E-02 0.000000000000000E+00 alpha(00001376)=0.000000000000000E+00 beta (00001377)=0.128972950296451E+02 gamma(00001377)=0.128972950296451E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.76706E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1377 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001377)=0.000000000000000E+00 beta (00001378)=0.135396626212959E+02 gamma(00001378)=0.135396626212959E+02 lr_calc_dens: Charge drift due to real space implementation = -0.64785E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1378 z1= 1 0.212537035661879E-02 0.000000000000000E+00 z1= 2 0.179253408761274E-02 0.000000000000000E+00 z1= 3 0.401679549224198E-02 0.000000000000000E+00 alpha(00001378)=0.000000000000000E+00 beta (00001379)=0.129587525300900E+02 gamma(00001379)=0.129587525300900E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.69353E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1379 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001379)=0.000000000000000E+00 beta (00001380)=0.136263617580193E+02 gamma(00001380)=0.136263617580193E+02 lr_calc_dens: Charge drift due to real space implementation = 0.78919E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1380 z1= 1 -.192000644042628E-02 0.000000000000000E+00 z1= 2 -.181905253474906E-02 0.000000000000000E+00 z1= 3 -.409265733807386E-02 0.000000000000000E+00 alpha(00001380)=0.000000000000000E+00 beta (00001381)=0.129594364633113E+02 gamma(00001381)=0.129594364633113E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.44060E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1381 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001381)=0.000000000000000E+00 beta (00001382)=0.135019631251244E+02 gamma(00001382)=0.135019631251244E+02 lr_calc_dens: Charge drift due to real space implementation = -0.65128E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1382 z1= 1 0.187066719284513E-02 0.000000000000000E+00 z1= 2 0.186083975210905E-02 0.000000000000000E+00 z1= 3 0.420989739946555E-02 0.000000000000000E+00 alpha(00001382)=0.000000000000000E+00 beta (00001383)=0.129966982253604E+02 gamma(00001383)=0.129966982253604E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.28968E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1383 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001383)=0.000000000000000E+00 beta (00001384)=0.135535734110583E+02 gamma(00001384)=0.135535734110583E+02 lr_calc_dens: Charge drift due to real space implementation = 0.38809E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1384 z1= 1 -.190871579795068E-02 0.000000000000000E+00 z1= 2 -.190418281520163E-02 0.000000000000000E+00 z1= 3 -.432435606595596E-02 0.000000000000000E+00 alpha(00001384)=0.000000000000000E+00 beta (00001385)=0.131271527003321E+02 gamma(00001385)=0.131271527003321E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.41341E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1385 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001385)=0.000000000000000E+00 beta (00001386)=0.135088219340733E+02 gamma(00001386)=0.135088219340733E+02 lr_calc_dens: Charge drift due to real space implementation = -0.32287E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1386 z1= 1 0.194986714752944E-02 0.000000000000000E+00 z1= 2 0.196701465182130E-02 0.000000000000000E+00 z1= 3 0.449226676845788E-02 0.000000000000000E+00 alpha(00001386)=0.000000000000000E+00 beta (00001387)=0.130428506867000E+02 gamma(00001387)=0.130428506867000E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.57777E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1387 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001387)=0.000000000000000E+00 beta (00001388)=0.135512000059322E+02 gamma(00001388)=0.135512000059322E+02 lr_calc_dens: Charge drift due to real space implementation = 0.44005E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1388 z1= 1 -.189530750428266E-02 0.000000000000000E+00 z1= 2 -.201833139855427E-02 0.000000000000000E+00 z1= 3 -.462034899627828E-02 0.000000000000000E+00 alpha(00001388)=0.000000000000000E+00 beta (00001389)=0.130686044561514E+02 gamma(00001389)=0.130686044561514E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.60166E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1389 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001389)=0.000000000000000E+00 beta (00001390)=0.135325858780187E+02 gamma(00001390)=0.135325858780187E+02 lr_calc_dens: Charge drift due to real space implementation = -0.57261E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1390 z1= 1 0.179625830792947E-02 0.000000000000000E+00 z1= 2 0.207055828547177E-02 0.000000000000000E+00 z1= 3 0.476305310568002E-02 0.000000000000000E+00 alpha(00001390)=0.000000000000000E+00 beta (00001391)=0.131050533081902E+02 gamma(00001391)=0.131050533081902E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.48024E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1391 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001391)=0.000000000000000E+00 beta (00001392)=0.135087085237675E+02 gamma(00001392)=0.135087085237675E+02 lr_calc_dens: Charge drift due to real space implementation = 0.60580E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1392 z1= 1 -.168061902385453E-02 0.000000000000000E+00 z1= 2 -.213579074463612E-02 0.000000000000000E+00 z1= 3 -.492897362365599E-02 0.000000000000000E+00 alpha(00001392)=0.000000000000000E+00 beta (00001393)=0.130318448855017E+02 gamma(00001393)=0.130318448855017E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.30601E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1393 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001393)=0.000000000000000E+00 beta (00001394)=0.134381821830245E+02 gamma(00001394)=0.134381821830245E+02 lr_calc_dens: Charge drift due to real space implementation = -0.43046E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1394 z1= 1 0.151653683473457E-02 0.000000000000000E+00 z1= 2 0.219353633618760E-02 0.000000000000000E+00 z1= 3 0.509226905382062E-02 0.000000000000000E+00 alpha(00001394)=0.000000000000000E+00 beta (00001395)=0.130077013182174E+02 gamma(00001395)=0.130077013182174E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.36415E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1395 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001395)=0.000000000000000E+00 beta (00001396)=0.135215954946836E+02 gamma(00001396)=0.135215954946836E+02 lr_calc_dens: Charge drift due to real space implementation = 0.39077E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1396 z1= 1 -.126530716324272E-02 0.000000000000000E+00 z1= 2 -.223874617446135E-02 0.000000000000000E+00 z1= 3 -.521481443370473E-02 0.000000000000000E+00 alpha(00001396)=0.000000000000000E+00 beta (00001397)=0.129069750623815E+02 gamma(00001397)=0.129069750623815E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.46162E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1397 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001397)=0.000000000000000E+00 beta (00001398)=0.134932674690248E+02 gamma(00001398)=0.134932674690248E+02 lr_calc_dens: Charge drift due to real space implementation = -0.48341E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1398 z1= 1 0.100492418532196E-02 0.000000000000000E+00 z1= 2 0.226768152552783E-02 0.000000000000000E+00 z1= 3 0.531167694187855E-02 0.000000000000000E+00 alpha(00001398)=0.000000000000000E+00 beta (00001399)=0.130348728022262E+02 gamma(00001399)=0.130348728022262E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.43271E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1399 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001399)=0.000000000000000E+00 beta (00001400)=0.135930389269919E+02 gamma(00001400)=0.135930389269919E+02 lr_calc_dens: Charge drift due to real space implementation = 0.55481E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1400 z1= 1 -.825538367094488E-03 0.000000000000000E+00 z1= 2 -.230532993134964E-02 0.000000000000000E+00 z1= 3 -.542123958128367E-02 0.000000000000000E+00 alpha(00001400)=0.000000000000000E+00 beta (00001401)=0.129492210554507E+02 gamma(00001401)=0.129492210554507E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.32030E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1401 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001401)=0.000000000000000E+00 beta (00001402)=0.135836734738268E+02 gamma(00001402)=0.135836734738268E+02 lr_calc_dens: Charge drift due to real space implementation = -0.51533E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1402 z1= 1 0.739411753104965E-03 0.000000000000000E+00 z1= 2 0.233257894717528E-02 0.000000000000000E+00 z1= 3 0.550430724146971E-02 0.000000000000000E+00 alpha(00001402)=0.000000000000000E+00 beta (00001403)=0.129509913489758E+02 gamma(00001403)=0.129509913489758E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.19179E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1403 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001403)=0.000000000000000E+00 beta (00001404)=0.134954280997297E+02 gamma(00001404)=0.134954280997297E+02 lr_calc_dens: Charge drift due to real space implementation = 0.33545E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1404 z1= 1 -.801558138311145E-03 0.000000000000000E+00 z1= 2 -.237708268063730E-02 0.000000000000000E+00 z1= 3 -.563153481571111E-02 0.000000000000000E+00 alpha(00001404)=0.000000000000000E+00 beta (00001405)=0.130506640439507E+02 gamma(00001405)=0.130506640439507E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.23310E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1405 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001405)=0.000000000000000E+00 beta (00001406)=0.135314441856823E+02 gamma(00001406)=0.135314441856823E+02 lr_calc_dens: Charge drift due to real space implementation = -0.24219E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1406 z1= 1 0.957385044887061E-03 0.000000000000000E+00 z1= 2 0.243191644786492E-02 0.000000000000000E+00 z1= 3 0.578284492942158E-02 0.000000000000000E+00 alpha(00001406)=0.000000000000000E+00 beta (00001407)=0.129560645671393E+02 gamma(00001407)=0.129560645671393E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.29707E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1407 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001407)=0.000000000000000E+00 beta (00001408)=0.134894343391691E+02 gamma(00001408)=0.134894343391691E+02 lr_calc_dens: Charge drift due to real space implementation = 0.17080E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1408 z1= 1 -.988868098299727E-03 0.000000000000000E+00 z1= 2 -.247339356457416E-02 0.000000000000000E+00 z1= 3 -.591553252637173E-02 0.000000000000000E+00 alpha(00001408)=0.000000000000000E+00 beta (00001409)=0.129685389417975E+02 gamma(00001409)=0.129685389417975E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.47103E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1409 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001409)=0.000000000000000E+00 beta (00001410)=0.135589036355492E+02 gamma(00001410)=0.135589036355492E+02 lr_calc_dens: Charge drift due to real space implementation = -0.28955E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1410 z1= 1 0.777497755936527E-03 0.000000000000000E+00 z1= 2 0.251040786229731E-02 0.000000000000000E+00 z1= 3 0.602286719148083E-02 0.000000000000000E+00 alpha(00001410)=0.000000000000000E+00 beta (00001411)=0.130158019917034E+02 gamma(00001411)=0.130158019917034E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.53799E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1411 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001411)=0.000000000000000E+00 beta (00001412)=0.134432337852041E+02 gamma(00001412)=0.134432337852041E+02 lr_calc_dens: Charge drift due to real space implementation = 0.48808E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1412 z1= 1 -.468533187705383E-03 0.000000000000000E+00 z1= 2 -.257749288078273E-02 0.000000000000000E+00 z1= 3 -.620789914460592E-02 0.000000000000000E+00 alpha(00001412)=0.000000000000000E+00 beta (00001413)=0.129784566634630E+02 gamma(00001413)=0.129784566634630E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.38561E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1413 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001413)=0.000000000000000E+00 beta (00001414)=0.134391444053530E+02 gamma(00001414)=0.134391444053530E+02 lr_calc_dens: Charge drift due to real space implementation = -0.49923E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1414 z1= 1 0.176553730217510E-03 0.000000000000000E+00 z1= 2 0.264061912799796E-02 0.000000000000000E+00 z1= 3 0.637628616515707E-02 0.000000000000000E+00 alpha(00001414)=0.000000000000000E+00 beta (00001415)=0.129557365504232E+02 gamma(00001415)=0.129557365504232E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.24887E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1415 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001415)=0.000000000000000E+00 beta (00001416)=0.135838535886083E+02 gamma(00001416)=0.135838535886083E+02 lr_calc_dens: Charge drift due to real space implementation = 0.39216E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1416 z1= 1 0.253735501248627E-04 0.000000000000000E+00 z1= 2 -.266605304796075E-02 0.000000000000000E+00 z1= 3 -.646435600582399E-02 0.000000000000000E+00 alpha(00001416)=0.000000000000000E+00 beta (00001417)=0.130458087996868E+02 gamma(00001417)=0.130458087996868E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.24446E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1417 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001417)=0.000000000000000E+00 beta (00001418)=0.134577299367013E+02 gamma(00001418)=0.134577299367013E+02 lr_calc_dens: Charge drift due to real space implementation = -0.37276E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1418 z1= 1 -.924845419006566E-04 0.000000000000000E+00 z1= 2 0.273714180762414E-02 0.000000000000000E+00 z1= 3 0.665949719330760E-02 0.000000000000000E+00 alpha(00001418)=0.000000000000000E+00 beta (00001419)=0.130636115371576E+02 gamma(00001419)=0.130636115371576E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.20316E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1419 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001419)=0.000000000000000E+00 beta (00001420)=0.135658995973968E+02 gamma(00001420)=0.135658995973968E+02 lr_calc_dens: Charge drift due to real space implementation = 0.31444E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1420 z1= 1 0.171991986204875E-03 0.000000000000000E+00 z1= 2 -.278861637907724E-02 0.000000000000000E+00 z1= 3 -.680582046548705E-02 0.000000000000000E+00 alpha(00001420)=0.000000000000000E+00 beta (00001421)=0.129379457637515E+02 gamma(00001421)=0.129379457637515E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.19415E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1421 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001421)=0.000000000000000E+00 beta (00001422)=0.136300400660360E+02 gamma(00001422)=0.136300400660360E+02 lr_calc_dens: Charge drift due to real space implementation = -0.23835E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1422 z1= 1 -.271529996943127E-03 0.000000000000000E+00 z1= 2 0.280408033194143E-02 0.000000000000000E+00 z1= 3 0.686059923560369E-02 0.000000000000000E+00 alpha(00001422)=0.000000000000000E+00 beta (00001423)=0.130388007989947E+02 gamma(00001423)=0.130388007989947E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.20026E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1423 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001423)=0.000000000000000E+00 beta (00001424)=0.135680161935853E+02 gamma(00001424)=0.135680161935853E+02 lr_calc_dens: Charge drift due to real space implementation = 0.87676E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1424 z1= 1 0.301110685175146E-03 0.000000000000000E+00 z1= 2 -.285379646776336E-02 0.000000000000000E+00 z1= 3 -.700516531540417E-02 0.000000000000000E+00 alpha(00001424)=0.000000000000000E+00 beta (00001425)=0.129467136267278E+02 gamma(00001425)=0.129467136267278E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.45749E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1425 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001425)=0.000000000000000E+00 beta (00001426)=0.135841507414606E+02 gamma(00001426)=0.135841507414606E+02 lr_calc_dens: Charge drift due to real space implementation = -0.28858E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1426 z1= 1 -.212564995825944E-03 0.000000000000000E+00 z1= 2 0.288353131416200E-02 0.000000000000000E+00 z1= 3 0.709847550702633E-02 0.000000000000000E+00 alpha(00001426)=0.000000000000000E+00 beta (00001427)=0.130084128479186E+02 gamma(00001427)=0.130084128479186E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.44569E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1427 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001427)=0.000000000000000E+00 beta (00001428)=0.135229901588508E+02 gamma(00001428)=0.135229901588508E+02 lr_calc_dens: Charge drift due to real space implementation = 0.44537E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1428 z1= 1 0.218697591739328E-06 0.000000000000000E+00 z1= 2 -.294125447736687E-02 0.000000000000000E+00 z1= 3 -.726224717350000E-02 0.000000000000000E+00 alpha(00001428)=0.000000000000000E+00 beta (00001429)=0.130123347866448E+02 gamma(00001429)=0.130123347866448E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.24109E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1429 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001429)=0.000000000000000E+00 beta (00001430)=0.136107144511062E+02 gamma(00001430)=0.136107144511062E+02 lr_calc_dens: Charge drift due to real space implementation = -0.33712E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1430 z1= 1 0.208203406782882E-03 0.000000000000000E+00 z1= 2 0.298022571550904E-02 0.000000000000000E+00 z1= 3 0.738246095080631E-02 0.000000000000000E+00 alpha(00001430)=0.000000000000000E+00 beta (00001431)=0.130131368996445E+02 gamma(00001431)=0.130131368996445E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.20279E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1431 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001431)=0.000000000000000E+00 beta (00001432)=0.134847181231489E+02 gamma(00001432)=0.134847181231489E+02 lr_calc_dens: Charge drift due to real space implementation = 0.26483E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1432 z1= 1 -.536366541095250E-03 0.000000000000000E+00 z1= 2 -.304799153514644E-02 0.000000000000000E+00 z1= 3 -.757853289252467E-02 0.000000000000000E+00 alpha(00001432)=0.000000000000000E+00 beta (00001433)=0.130159589573270E+02 gamma(00001433)=0.130159589573270E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.19723E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1433 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001433)=0.000000000000000E+00 beta (00001434)=0.134877383322401E+02 gamma(00001434)=0.134877383322401E+02 lr_calc_dens: Charge drift due to real space implementation = -0.18896E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1434 z1= 1 0.996885319125597E-03 0.000000000000000E+00 z1= 2 0.311656620662825E-02 0.000000000000000E+00 z1= 3 0.777373974733030E-02 0.000000000000000E+00 alpha(00001434)=0.000000000000000E+00 beta (00001435)=0.129929899106694E+02 gamma(00001435)=0.129929899106694E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.27113E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1435 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001435)=0.000000000000000E+00 beta (00001436)=0.134991932418603E+02 gamma(00001436)=0.134991932418603E+02 lr_calc_dens: Charge drift due to real space implementation = 0.19810E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1436 z1= 1 -.137702445904304E-02 0.000000000000000E+00 z1= 2 -.317792365418687E-02 0.000000000000000E+00 z1= 3 -.794885198591487E-02 0.000000000000000E+00 alpha(00001436)=0.000000000000000E+00 beta (00001437)=0.130597591626396E+02 gamma(00001437)=0.130597591626396E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.29862E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1437 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001437)=0.000000000000000E+00 beta (00001438)=0.134959787282170E+02 gamma(00001438)=0.134959787282170E+02 lr_calc_dens: Charge drift due to real space implementation = -0.21391E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1438 z1= 1 0.160070612869134E-02 0.000000000000000E+00 z1= 2 0.325181311562259E-02 0.000000000000000E+00 z1= 3 0.816453731800189E-02 0.000000000000000E+00 alpha(00001438)=0.000000000000000E+00 beta (00001439)=0.129820012787328E+02 gamma(00001439)=0.129820012787328E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.33085E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1439 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001439)=0.000000000000000E+00 beta (00001440)=0.134813187571090E+02 gamma(00001440)=0.134813187571090E+02 lr_calc_dens: Charge drift due to real space implementation = 0.25105E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1440 z1= 1 -.162847157483412E-02 0.000000000000000E+00 z1= 2 -.331424830117489E-02 0.000000000000000E+00 z1= 3 -.834257719622957E-02 0.000000000000000E+00 alpha(00001440)=0.000000000000000E+00 beta (00001441)=0.130271547716613E+02 gamma(00001441)=0.130271547716613E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.34806E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1441 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001441)=0.000000000000000E+00 beta (00001442)=0.134841634947996E+02 gamma(00001442)=0.134841634947996E+02 lr_calc_dens: Charge drift due to real space implementation = -0.34569E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1442 z1= 1 0.159169469246294E-02 0.000000000000000E+00 z1= 2 0.338413204153503E-02 0.000000000000000E+00 z1= 3 0.854614226573835E-02 0.000000000000000E+00 alpha(00001442)=0.000000000000000E+00 beta (00001443)=0.130951857699934E+02 gamma(00001443)=0.130951857699934E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.24307E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1443 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001443)=0.000000000000000E+00 beta (00001444)=0.134886069278030E+02 gamma(00001444)=0.134886069278030E+02 lr_calc_dens: Charge drift due to real space implementation = 0.32734E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1444 z1= 1 -.159199822971155E-02 0.000000000000000E+00 z1= 2 -.347003047834075E-02 0.000000000000000E+00 z1= 3 -.878580125130056E-02 0.000000000000000E+00 alpha(00001444)=0.000000000000000E+00 beta (00001445)=0.129492192248052E+02 gamma(00001445)=0.129492192248052E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.16844E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1445 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001445)=0.000000000000000E+00 beta (00001446)=0.134325733145847E+02 gamma(00001446)=0.134325733145847E+02 lr_calc_dens: Charge drift due to real space implementation = -0.23266E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1446 z1= 1 0.161430991416399E-02 0.000000000000000E+00 z1= 2 0.353447935552821E-02 0.000000000000000E+00 z1= 3 0.897135011278713E-02 0.000000000000000E+00 alpha(00001446)=0.000000000000000E+00 beta (00001447)=0.130384915721473E+02 gamma(00001447)=0.130384915721473E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.18553E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1447 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001447)=0.000000000000000E+00 beta (00001448)=0.134795078435076E+02 gamma(00001448)=0.134795078435076E+02 lr_calc_dens: Charge drift due to real space implementation = 0.17990E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1448 z1= 1 -.163289617432417E-02 0.000000000000000E+00 z1= 2 -.360797591325239E-02 0.000000000000000E+00 z1= 3 -.918057194564462E-02 0.000000000000000E+00 alpha(00001448)=0.000000000000000E+00 beta (00001449)=0.130068142836033E+02 gamma(00001449)=0.130068142836033E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.22322E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1449 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001449)=0.000000000000000E+00 beta (00001450)=0.135281550101319E+02 gamma(00001450)=0.135281550101319E+02 lr_calc_dens: Charge drift due to real space implementation = -0.19931E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1450 z1= 1 0.154997899686633E-02 0.000000000000000E+00 z1= 2 0.365928387029527E-02 0.000000000000000E+00 z1= 3 0.933473924615899E-02 0.000000000000000E+00 alpha(00001450)=0.000000000000000E+00 beta (00001451)=0.129650481540169E+02 gamma(00001451)=0.129650481540169E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.19428E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1451 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001451)=0.000000000000000E+00 beta (00001452)=0.134947870205733E+02 gamma(00001452)=0.134947870205733E+02 lr_calc_dens: Charge drift due to real space implementation = 0.17233E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1452 z1= 1 -.137351742090368E-02 0.000000000000000E+00 z1= 2 -.371266692988137E-02 0.000000000000000E+00 z1= 3 -.948528056785562E-02 0.000000000000000E+00 alpha(00001452)=0.000000000000000E+00 beta (00001453)=0.130092339701072E+02 gamma(00001453)=0.130092339701072E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.19558E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1453 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001453)=0.000000000000000E+00 beta (00001454)=0.134601681670054E+02 gamma(00001454)=0.134601681670054E+02 lr_calc_dens: Charge drift due to real space implementation = -0.13325E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1454 z1= 1 0.106751629959931E-02 0.000000000000000E+00 z1= 2 0.378697722697413E-02 0.000000000000000E+00 z1= 3 0.969432823217211E-02 0.000000000000000E+00 alpha(00001454)=0.000000000000000E+00 beta (00001455)=0.130550769095609E+02 gamma(00001455)=0.130550769095609E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.28056E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1455 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001455)=0.000000000000000E+00 beta (00001456)=0.134611750924120E+02 gamma(00001456)=0.134611750924120E+02 lr_calc_dens: Charge drift due to real space implementation = 0.21115E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1456 z1= 1 -.537951393513122E-03 0.000000000000000E+00 z1= 2 -.387057749994785E-02 0.000000000000000E+00 z1= 3 -.993101075662989E-02 0.000000000000000E+00 alpha(00001456)=0.000000000000000E+00 beta (00001457)=0.129941682325890E+02 gamma(00001457)=0.129941682325890E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.26496E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1457 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001457)=0.000000000000000E+00 beta (00001458)=0.135489421454769E+02 gamma(00001458)=0.135489421454769E+02 lr_calc_dens: Charge drift due to real space implementation = -0.27296E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1458 z1= 1 -.131827130899810E-03 0.000000000000000E+00 z1= 2 0.390678188370192E-02 0.000000000000000E+00 z1= 3 0.100593791898467E-01 0.000000000000000E+00 alpha(00001458)=0.000000000000000E+00 beta (00001459)=0.129759933493031E+02 gamma(00001459)=0.129759933493031E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.17305E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1459 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001459)=0.000000000000000E+00 beta (00001460)=0.134064739937370E+02 gamma(00001460)=0.134064739937370E+02 lr_calc_dens: Charge drift due to real space implementation = 0.20961E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1460 z1= 1 0.891662285871964E-03 0.000000000000000E+00 z1= 2 -.398466091664566E-02 0.000000000000000E+00 z1= 3 -.102865882193658E-01 0.000000000000000E+00 alpha(00001460)=0.000000000000000E+00 beta (00001461)=0.129373250766558E+02 gamma(00001461)=0.129373250766558E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.20569E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1461 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001461)=0.000000000000000E+00 beta (00001462)=0.134849071144382E+02 gamma(00001462)=0.134849071144382E+02 lr_calc_dens: Charge drift due to real space implementation = -0.23318E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1462 z1= 1 -.158865181922373E-02 0.000000000000000E+00 z1= 2 0.402833210051166E-02 0.000000000000000E+00 z1= 3 0.104251034079311E-01 0.000000000000000E+00 alpha(00001462)=0.000000000000000E+00 beta (00001463)=0.130281096862347E+02 gamma(00001463)=0.130281096862347E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.20120E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1463 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001463)=0.000000000000000E+00 beta (00001464)=0.135183527713625E+02 gamma(00001464)=0.135183527713625E+02 lr_calc_dens: Charge drift due to real space implementation = 0.27388E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1464 z1= 1 0.218128145752931E-02 0.000000000000000E+00 z1= 2 -.409236285312591E-02 0.000000000000000E+00 z1= 3 -.106056006763644E-01 0.000000000000000E+00 alpha(00001464)=0.000000000000000E+00 beta (00001465)=0.129095431368930E+02 gamma(00001465)=0.129095431368930E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11429E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1465 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001465)=0.000000000000000E+00 beta (00001466)=0.134248030971686E+02 gamma(00001466)=0.134248030971686E+02 lr_calc_dens: Charge drift due to real space implementation = -0.23184E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1466 z1= 1 -.277544856550731E-02 0.000000000000000E+00 z1= 2 0.414889725516149E-02 0.000000000000000E+00 z1= 3 0.107762121920534E-01 0.000000000000000E+00 alpha(00001466)=0.000000000000000E+00 beta (00001467)=0.130204220821263E+02 gamma(00001467)=0.130204220821263E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.57451E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1467 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001467)=0.000000000000000E+00 beta (00001468)=0.134074179931911E+02 gamma(00001468)=0.134074179931911E+02 lr_calc_dens: Charge drift due to real space implementation = 0.16311E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1468 z1= 1 0.339449547017149E-02 0.000000000000000E+00 z1= 2 -.423691477192778E-02 0.000000000000000E+00 z1= 3 -.110444635580138E-01 0.000000000000000E+00 alpha(00001468)=0.000000000000000E+00 beta (00001469)=0.130680865367381E+02 gamma(00001469)=0.130680865367381E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.31827E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1469 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001469)=0.000000000000000E+00 beta (00001470)=0.134988343996047E+02 gamma(00001470)=0.134988343996047E+02 lr_calc_dens: Charge drift due to real space implementation = -0.74165E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1470 z1= 1 -.393670369991999E-02 0.000000000000000E+00 z1= 2 0.431086836571150E-02 0.000000000000000E+00 z1= 3 0.112718678329871E-01 0.000000000000000E+00 alpha(00001470)=0.000000000000000E+00 beta (00001471)=0.130685594060255E+02 gamma(00001471)=0.130685594060255E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10179E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1471 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001471)=0.000000000000000E+00 beta (00001472)=0.134831378242514E+02 gamma(00001472)=0.134831378242514E+02 lr_calc_dens: Charge drift due to real space implementation = 0.79559E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1472 z1= 1 0.430229476843611E-02 0.000000000000000E+00 z1= 2 -.438726150029115E-02 0.000000000000000E+00 z1= 3 -.115061138098646E-01 0.000000000000000E+00 alpha(00001472)=0.000000000000000E+00 beta (00001473)=0.130713180611672E+02 gamma(00001473)=0.130713180611672E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.14101E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1473 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001473)=0.000000000000000E+00 beta (00001474)=0.135203171611908E+02 gamma(00001474)=0.135203171611908E+02 lr_calc_dens: Charge drift due to real space implementation = -0.85088E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1474 z1= 1 -.447660452070228E-02 0.000000000000000E+00 z1= 2 0.445246716422717E-02 0.000000000000000E+00 z1= 3 0.117110400665487E-01 0.000000000000000E+00 alpha(00001474)=0.000000000000000E+00 beta (00001475)=0.130296444335133E+02 gamma(00001475)=0.130296444335133E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.23875E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1475 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001475)=0.000000000000000E+00 beta (00001476)=0.134691006116719E+02 gamma(00001476)=0.134691006116719E+02 lr_calc_dens: Charge drift due to real space implementation = 0.21978E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1476 z1= 1 0.459718835870947E-02 0.000000000000000E+00 z1= 2 -.452046869311212E-02 0.000000000000000E+00 z1= 3 -.119199730241161E-01 0.000000000000000E+00 alpha(00001476)=0.000000000000000E+00 beta (00001477)=0.130184906215832E+02 gamma(00001477)=0.130184906215832E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.16946E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1477 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001477)=0.000000000000000E+00 beta (00001478)=0.135651885737527E+02 gamma(00001478)=0.135651885737527E+02 lr_calc_dens: Charge drift due to real space implementation = -0.27530E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1478 z1= 1 -.467536186709238E-02 0.000000000000000E+00 z1= 2 0.455224552526648E-02 0.000000000000000E+00 z1= 3 0.120360309419603E-01 0.000000000000000E+00 alpha(00001478)=0.000000000000000E+00 beta (00001479)=0.130699753626218E+02 gamma(00001479)=0.130699753626218E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.31634E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1479 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001479)=0.000000000000000E+00 beta (00001480)=0.134607440084160E+02 gamma(00001480)=0.134607440084160E+02 lr_calc_dens: Charge drift due to real space implementation = 0.18675E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1480 z1= 1 0.483084808817553E-02 0.000000000000000E+00 z1= 2 -.463529941436669E-02 0.000000000000000E+00 z1= 3 -.122887631061823E-01 0.000000000000000E+00 alpha(00001480)=0.000000000000000E+00 beta (00001481)=0.130979218206774E+02 gamma(00001481)=0.130979218206774E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10980E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1481 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001481)=0.000000000000000E+00 beta (00001482)=0.135736004996333E+02 gamma(00001482)=0.135736004996333E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10081E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1482 z1= 1 -.502735567295593E-02 0.000000000000000E+00 z1= 2 0.468705955979685E-02 0.000000000000000E+00 z1= 3 0.124615588276757E-01 0.000000000000000E+00 alpha(00001482)=0.000000000000000E+00 beta (00001483)=0.130011406544442E+02 gamma(00001483)=0.130011406544442E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.39255E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1483 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001483)=0.000000000000000E+00 beta (00001484)=0.133978828058080E+02 gamma(00001484)=0.133978828058080E+02 lr_calc_dens: Charge drift due to real space implementation = 0.13122E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1484 z1= 1 0.530238659103793E-02 0.000000000000000E+00 z1= 2 -.476869886538643E-02 0.000000000000000E+00 z1= 3 -.127096019525127E-01 0.000000000000000E+00 alpha(00001484)=0.000000000000000E+00 beta (00001485)=0.130433101832227E+02 gamma(00001485)=0.130433101832227E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.41345E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1485 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001485)=0.000000000000000E+00 beta (00001486)=0.135479023029247E+02 gamma(00001486)=0.135479023029247E+02 lr_calc_dens: Charge drift due to real space implementation = -0.24813E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1486 z1= 1 -.545486026947448E-02 0.000000000000000E+00 z1= 2 0.480506511058778E-02 0.000000000000000E+00 z1= 3 0.128522345922083E-01 0.000000000000000E+00 alpha(00001486)=0.000000000000000E+00 beta (00001487)=0.129568739834725E+02 gamma(00001487)=0.129568739834725E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.24129E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1487 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001487)=0.000000000000000E+00 beta (00001488)=0.135667408157669E+02 gamma(00001488)=0.135667408157669E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11642E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1488 z1= 1 0.541218406761183E-02 0.000000000000000E+00 z1= 2 -.481064446020492E-02 0.000000000000000E+00 z1= 3 -.128962752379277E-01 0.000000000000000E+00 alpha(00001488)=0.000000000000000E+00 beta (00001489)=0.130973375168675E+02 gamma(00001489)=0.130973375168675E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.15144E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1489 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001489)=0.000000000000000E+00 beta (00001490)=0.135051280874277E+02 gamma(00001490)=0.135051280874277E+02 lr_calc_dens: Charge drift due to real space implementation = 0.98905E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1490 z1= 1 -.529886088304064E-02 0.000000000000000E+00 z1= 2 0.488888286128112E-02 0.000000000000000E+00 z1= 3 0.131425323110066E-01 0.000000000000000E+00 alpha(00001490)=0.000000000000000E+00 beta (00001491)=0.130494332539278E+02 gamma(00001491)=0.130494332539278E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.36722E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1491 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001491)=0.000000000000000E+00 beta (00001492)=0.133946385870731E+02 gamma(00001492)=0.133946385870731E+02 lr_calc_dens: Charge drift due to real space implementation = 0.16873E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1492 z1= 1 0.517079965107769E-02 0.000000000000000E+00 z1= 2 -.498921542986130E-02 0.000000000000000E+00 z1= 3 -.134454087102120E-01 0.000000000000000E+00 alpha(00001492)=0.000000000000000E+00 beta (00001493)=0.130346653535869E+02 gamma(00001493)=0.130346653535869E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.24900E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1493 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001493)=0.000000000000000E+00 beta (00001494)=0.134156387904567E+02 gamma(00001494)=0.134156387904567E+02 lr_calc_dens: Charge drift due to real space implementation = -0.23281E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1494 z1= 1 -.508105129924997E-02 0.000000000000000E+00 z1= 2 0.507105297240050E-02 0.000000000000000E+00 z1= 3 0.137095712116829E-01 0.000000000000000E+00 alpha(00001494)=0.000000000000000E+00 beta (00001495)=0.130947809259799E+02 gamma(00001495)=0.130947809259799E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14723E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1495 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001495)=0.000000000000000E+00 beta (00001496)=0.134732896161867E+02 gamma(00001496)=0.134732896161867E+02 lr_calc_dens: Charge drift due to real space implementation = 0.22872E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1496 z1= 1 0.499120323376052E-02 0.000000000000000E+00 z1= 2 -.515257708914252E-02 0.000000000000000E+00 z1= 3 -.139612408875954E-01 0.000000000000000E+00 alpha(00001496)=0.000000000000000E+00 beta (00001497)=0.131048844248554E+02 gamma(00001497)=0.131048844248554E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.22761E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1497 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001497)=0.000000000000000E+00 beta (00001498)=0.133948088955943E+02 gamma(00001498)=0.133948088955943E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10652E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1498 z1= 1 -.490259100586522E-02 0.000000000000000E+00 z1= 2 0.526334659451057E-02 0.000000000000000E+00 z1= 3 0.143036348160396E-01 0.000000000000000E+00 alpha(00001498)=0.000000000000000E+00 beta (00001499)=0.131006262372556E+02 gamma(00001499)=0.131006262372556E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.54324E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1499 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001499)=0.000000000000000E+00 beta (00001500)=0.133699694404554E+02 gamma(00001500)=0.133699694404554E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11203E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1500 z1= 1 0.469847841405750E-02 0.000000000000000E+00 z1= 2 -.537812644456265E-02 0.000000000000000E+00 z1= 3 -.146530104817632E-01 0.000000000000000E+00 alpha(00001500)=0.000000000000000E+00 beta (00001501)=0.129679315195606E+02 gamma(00001501)=0.129679315195606E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.78437E-10 lr_apply_liouvillian: applying interaction: normal There are missing files! lanczos restart files can not be found, starting run from scratch Norm of initial Lanczos vectors= 3.850163354607945 Starting Lanczos loop 2 Lanczos iteration: 1 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.14103E-05 lr_apply_liouvillian: applying interaction: normal alpha(00000001)=0.000000000000000E+00 beta (00000002)=0.189718441463844E+01 gamma(00000002)=0.189718441463844E+01 lr_calc_dens: Charge drift due to real space implementation = -0.22206E-05 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 2 z1= 1 0.105752485176150E-05 0.000000000000000E+00 z1= 2 0.217096282093489E+01 0.000000000000000E+00 z1= 3 0.250582269846978E-06 0.000000000000000E+00 alpha(00000002)=0.000000000000000E+00 beta (00000003)=0.894699962984565E+01 gamma(00000003)=0.894699962984565E+01 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.17380E-05 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 3 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000003)=0.000000000000000E+00 beta (00000004)=0.140234403084699E+02 gamma(00000004)=0.140234403084699E+02 lr_calc_dens: Charge drift due to real space implementation = -0.34511E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 4 z1= 1 0.608851630653617E-06 0.000000000000000E+00 z1= 2 -.107592355267794E+01 0.000000000000000E+00 z1= 3 -.364232129950887E-06 0.000000000000000E+00 alpha(00000004)=0.000000000000000E+00 beta (00000005)=0.113243195156119E+02 gamma(00000005)=0.113243195156119E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.73977E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 5 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000005)=0.000000000000000E+00 beta (00000006)=0.154814962510982E+02 gamma(00000006)=0.154814962510982E+02 lr_calc_dens: Charge drift due to real space implementation = 0.25307E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 6 z1= 1 -.967410484242238E-06 0.000000000000000E+00 z1= 2 0.698880829899853E+00 0.000000000000000E+00 z1= 3 0.261908221936617E-06 0.000000000000000E+00 alpha(00000006)=0.000000000000000E+00 beta (00000007)=0.112755841332600E+02 gamma(00000007)=0.112755841332600E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.72624E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 7 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000007)=0.000000000000000E+00 beta (00000008)=0.143409453974245E+02 gamma(00000008)=0.143409453974245E+02 lr_calc_dens: Charge drift due to real space implementation = -0.35823E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 8 z1= 1 0.139514734120820E-05 0.000000000000000E+00 z1= 2 -.496707929704252E+00 0.000000000000000E+00 z1= 3 -.123355601453508E-06 0.000000000000000E+00 alpha(00000008)=0.000000000000000E+00 beta (00000009)=0.126059906500541E+02 gamma(00000009)=0.126059906500541E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.55418E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 9 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000009)=0.000000000000000E+00 beta (00000010)=0.133430361295139E+02 gamma(00000010)=0.133430361295139E+02 lr_calc_dens: Charge drift due to real space implementation = 0.42801E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 10 z1= 1 -.275298700862583E-05 0.000000000000000E+00 z1= 2 0.435884757444022E+00 0.000000000000000E+00 z1= 3 0.744903254142391E-07 0.000000000000000E+00 alpha(00000010)=0.000000000000000E+00 beta (00000011)=0.132035309713246E+02 gamma(00000011)=0.132035309713246E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.23406E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 11 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000011)=0.000000000000000E+00 beta (00000012)=0.132104225267356E+02 gamma(00000012)=0.132104225267356E+02 lr_calc_dens: Charge drift due to real space implementation = -0.28341E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 12 z1= 1 0.471408997472348E-05 0.000000000000000E+00 z1= 2 -.415560706363445E+00 0.000000000000000E+00 z1= 3 -.433554316105168E-07 0.000000000000000E+00 alpha(00000012)=0.000000000000000E+00 beta (00000013)=0.131706006698766E+02 gamma(00000013)=0.131706006698766E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.18733E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 13 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000013)=0.000000000000000E+00 beta (00000014)=0.134409946636361E+02 gamma(00000014)=0.134409946636361E+02 lr_calc_dens: Charge drift due to real space implementation = 0.25768E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 14 z1= 1 -.633010699458867E-05 0.000000000000000E+00 z1= 2 0.393248647501421E+00 0.000000000000000E+00 z1= 3 0.560892514190705E-07 0.000000000000000E+00 alpha(00000014)=0.000000000000000E+00 beta (00000015)=0.130837544174403E+02 gamma(00000015)=0.130837544174403E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.28054E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 15 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000015)=0.000000000000000E+00 beta (00000016)=0.135090377944348E+02 gamma(00000016)=0.135090377944348E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10771E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 16 z1= 1 0.749108874964488E-05 0.000000000000000E+00 z1= 2 -.368240492209912E+00 0.000000000000000E+00 z1= 3 -.396756304408601E-07 0.000000000000000E+00 alpha(00000016)=0.000000000000000E+00 beta (00000017)=0.130619476869830E+02 gamma(00000017)=0.130619476869830E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12103E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 17 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000017)=0.000000000000000E+00 beta (00000018)=0.134482319694491E+02 gamma(00000018)=0.134482319694491E+02 lr_calc_dens: Charge drift due to real space implementation = -0.96313E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 18 z1= 1 -.839184476213845E-05 0.000000000000000E+00 z1= 2 0.344268722880745E+00 0.000000000000000E+00 z1= 3 0.639700290238613E-07 0.000000000000000E+00 alpha(00000018)=0.000000000000000E+00 beta (00000019)=0.130478397449395E+02 gamma(00000019)=0.130478397449395E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.17217E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 19 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000019)=0.000000000000000E+00 beta (00000020)=0.133619034869353E+02 gamma(00000020)=0.133619034869353E+02 lr_calc_dens: Charge drift due to real space implementation = 0.52906E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 20 z1= 1 0.876286026757316E-05 0.000000000000000E+00 z1= 2 -.321503227748422E+00 0.000000000000000E+00 z1= 3 -.513748886359007E-07 0.000000000000000E+00 alpha(00000020)=0.000000000000000E+00 beta (00000021)=0.132268916566120E+02 gamma(00000021)=0.132268916566120E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.18657E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 21 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000021)=0.000000000000000E+00 beta (00000022)=0.132716101325273E+02 gamma(00000022)=0.132716101325273E+02 lr_calc_dens: Charge drift due to real space implementation = -0.33680E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 22 z1= 1 -.980090500669016E-05 0.000000000000000E+00 z1= 2 0.305207502314964E+00 0.000000000000000E+00 z1= 3 0.829683773689866E-07 0.000000000000000E+00 alpha(00000022)=0.000000000000000E+00 beta (00000023)=0.133238924084437E+02 gamma(00000023)=0.133238924084437E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.19195E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 23 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000023)=0.000000000000000E+00 beta (00000024)=0.131745652096963E+02 gamma(00000024)=0.131745652096963E+02 lr_calc_dens: Charge drift due to real space implementation = 0.55431E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 24 z1= 1 0.110940096037454E-04 0.000000000000000E+00 z1= 2 -.294128046423776E+00 0.000000000000000E+00 z1= 3 -.729597011634527E-07 0.000000000000000E+00 alpha(00000024)=0.000000000000000E+00 beta (00000025)=0.132188766931946E+02 gamma(00000025)=0.132188766931946E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.25157E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 25 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000025)=0.000000000000000E+00 beta (00000026)=0.132844755759662E+02 gamma(00000026)=0.132844755759662E+02 lr_calc_dens: Charge drift due to real space implementation = -0.28321E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 26 z1= 1 -.132220815123632E-04 0.000000000000000E+00 z1= 2 0.280045889452155E+00 0.000000000000000E+00 z1= 3 0.802197123885423E-07 0.000000000000000E+00 alpha(00000026)=0.000000000000000E+00 beta (00000027)=0.132524753624322E+02 gamma(00000027)=0.132524753624322E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.30114E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 27 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000027)=0.000000000000000E+00 beta (00000028)=0.134110730328367E+02 gamma(00000028)=0.134110730328367E+02 lr_calc_dens: Charge drift due to real space implementation = -0.53792E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 28 z1= 1 0.139920765365137E-04 0.000000000000000E+00 z1= 2 -.266358885055045E+00 0.000000000000000E+00 z1= 3 -.532596758835123E-07 0.000000000000000E+00 alpha(00000028)=0.000000000000000E+00 beta (00000029)=0.131203314530176E+02 gamma(00000029)=0.131203314530176E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.27716E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 29 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000029)=0.000000000000000E+00 beta (00000030)=0.132947507592234E+02 gamma(00000030)=0.132947507592234E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11435E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 30 z1= 1 -.138989654592638E-04 0.000000000000000E+00 z1= 2 0.254226774630966E+00 0.000000000000000E+00 z1= 3 0.572667201488150E-07 0.000000000000000E+00 alpha(00000030)=0.000000000000000E+00 beta (00000031)=0.131297123808826E+02 gamma(00000031)=0.131297123808826E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.21593E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 31 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000031)=0.000000000000000E+00 beta (00000032)=0.133954785814334E+02 gamma(00000032)=0.133954785814334E+02 lr_calc_dens: Charge drift due to real space implementation = -0.16198E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 32 z1= 1 0.119563137839481E-04 0.000000000000000E+00 z1= 2 -.241976426290461E+00 0.000000000000000E+00 z1= 3 -.575815204308053E-07 0.000000000000000E+00 alpha(00000032)=0.000000000000000E+00 beta (00000033)=0.131370174763173E+02 gamma(00000033)=0.131370174763173E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10262E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 33 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000033)=0.000000000000000E+00 beta (00000034)=0.133513354463902E+02 gamma(00000034)=0.133513354463902E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12551E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 34 z1= 1 -.100578058786485E-04 0.000000000000000E+00 z1= 2 0.231508928503842E+00 0.000000000000000E+00 z1= 3 0.682335165389861E-07 0.000000000000000E+00 alpha(00000034)=0.000000000000000E+00 beta (00000035)=0.131722483991626E+02 gamma(00000035)=0.131722483991626E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.40108E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 35 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000035)=0.000000000000000E+00 beta (00000036)=0.134508177514813E+02 gamma(00000036)=0.134508177514813E+02 lr_calc_dens: Charge drift due to real space implementation = -0.81726E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 36 z1= 1 0.867394709698141E-05 0.000000000000000E+00 z1= 2 -.220267617146592E+00 0.000000000000000E+00 z1= 3 -.841080715861340E-07 0.000000000000000E+00 alpha(00000036)=0.000000000000000E+00 beta (00000037)=0.130985992048652E+02 gamma(00000037)=0.130985992048652E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.19313E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 37 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000037)=0.000000000000000E+00 beta (00000038)=0.133468114605814E+02 gamma(00000038)=0.133468114605814E+02 lr_calc_dens: Charge drift due to real space implementation = 0.58686E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 38 z1= 1 -.794853128252733E-05 0.000000000000000E+00 z1= 2 0.209200191576445E+00 0.000000000000000E+00 z1= 3 0.137097155401410E-06 0.000000000000000E+00 alpha(00000038)=0.000000000000000E+00 beta (00000039)=0.131739007533373E+02 gamma(00000039)=0.131739007533373E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12933E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 39 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000039)=0.000000000000000E+00 beta (00000040)=0.134134565623621E+02 gamma(00000040)=0.134134565623621E+02 lr_calc_dens: Charge drift due to real space implementation = -0.44959E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 40 z1= 1 0.726195478440404E-05 0.000000000000000E+00 z1= 2 -.197906503530264E+00 0.000000000000000E+00 z1= 3 -.100213365775178E-06 0.000000000000000E+00 alpha(00000040)=0.000000000000000E+00 beta (00000041)=0.131035373193631E+02 gamma(00000041)=0.131035373193631E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.20732E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 41 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000041)=0.000000000000000E+00 beta (00000042)=0.133896903247532E+02 gamma(00000042)=0.133896903247532E+02 lr_calc_dens: Charge drift due to real space implementation = 0.48189E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 42 z1= 1 -.655273162420388E-05 0.000000000000000E+00 z1= 2 0.185456850251709E+00 0.000000000000000E+00 z1= 3 0.768793601565815E-07 0.000000000000000E+00 alpha(00000042)=0.000000000000000E+00 beta (00000043)=0.132308206313227E+02 gamma(00000043)=0.132308206313227E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.33276E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 43 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000043)=0.000000000000000E+00 beta (00000044)=0.133783098090742E+02 gamma(00000044)=0.133783098090742E+02 lr_calc_dens: Charge drift due to real space implementation = -0.69634E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 44 z1= 1 0.466393654477253E-05 0.000000000000000E+00 z1= 2 -.174843397471157E+00 0.000000000000000E+00 z1= 3 -.139577116608282E-06 0.000000000000000E+00 alpha(00000044)=0.000000000000000E+00 beta (00000045)=0.131446925359071E+02 gamma(00000045)=0.131446925359071E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.18864E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 45 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000045)=0.000000000000000E+00 beta (00000046)=0.133920370770922E+02 gamma(00000046)=0.133920370770922E+02 lr_calc_dens: Charge drift due to real space implementation = 0.59722E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 46 z1= 1 -.262143085787148E-05 0.000000000000000E+00 z1= 2 0.163007821521120E+00 0.000000000000000E+00 z1= 3 0.118199896544563E-06 0.000000000000000E+00 alpha(00000046)=0.000000000000000E+00 beta (00000047)=0.131685147982702E+02 gamma(00000047)=0.131685147982702E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12054E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 47 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000047)=0.000000000000000E+00 beta (00000048)=0.133550546178343E+02 gamma(00000048)=0.133550546178343E+02 lr_calc_dens: Charge drift due to real space implementation = -0.35674E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 48 z1= 1 0.160382135992038E-06 0.000000000000000E+00 z1= 2 -.152316171366437E+00 0.000000000000000E+00 z1= 3 -.101340600484787E-06 0.000000000000000E+00 alpha(00000048)=0.000000000000000E+00 beta (00000049)=0.131484615509036E+02 gamma(00000049)=0.131484615509036E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.29066E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 49 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000049)=0.000000000000000E+00 beta (00000050)=0.133602742892338E+02 gamma(00000050)=0.133602742892338E+02 lr_calc_dens: Charge drift due to real space implementation = 0.26950E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 50 z1= 1 0.114577883003446E-05 0.000000000000000E+00 z1= 2 0.141853794402946E+00 0.000000000000000E+00 z1= 3 0.781820642111817E-07 0.000000000000000E+00 alpha(00000050)=0.000000000000000E+00 beta (00000051)=0.131314655595303E+02 gamma(00000051)=0.131314655595303E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.41952E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 51 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000051)=0.000000000000000E+00 beta (00000052)=0.133881165725275E+02 gamma(00000052)=0.133881165725275E+02 lr_calc_dens: Charge drift due to real space implementation = -0.20322E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 52 z1= 1 -.270008784902277E-05 0.000000000000000E+00 z1= 2 -.131499683431260E+00 0.000000000000000E+00 z1= 3 -.797317758016425E-07 0.000000000000000E+00 alpha(00000052)=0.000000000000000E+00 beta (00000053)=0.131739344947688E+02 gamma(00000053)=0.131739344947688E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.56969E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 53 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000053)=0.000000000000000E+00 beta (00000054)=0.133625742059208E+02 gamma(00000054)=0.133625742059208E+02 lr_calc_dens: Charge drift due to real space implementation = 0.37781E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 54 z1= 1 0.288752986149325E-05 0.000000000000000E+00 z1= 2 0.122359983849742E+00 0.000000000000000E+00 z1= 3 0.175928725409391E-06 0.000000000000000E+00 alpha(00000054)=0.000000000000000E+00 beta (00000055)=0.130448026814868E+02 gamma(00000055)=0.130448026814868E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.48266E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 55 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000055)=0.000000000000000E+00 beta (00000056)=0.133630289246949E+02 gamma(00000056)=0.133630289246949E+02 lr_calc_dens: Charge drift due to real space implementation = -0.43964E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 56 z1= 1 -.321536307471351E-05 0.000000000000000E+00 z1= 2 -.112391499107851E+00 0.000000000000000E+00 z1= 3 -.208452973105805E-06 0.000000000000000E+00 alpha(00000056)=0.000000000000000E+00 beta (00000057)=0.130834699648664E+02 gamma(00000057)=0.130834699648664E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.51956E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 57 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000057)=0.000000000000000E+00 beta (00000058)=0.133938422028673E+02 gamma(00000058)=0.133938422028673E+02 lr_calc_dens: Charge drift due to real space implementation = 0.76523E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 58 z1= 1 0.479104983714188E-05 0.000000000000000E+00 z1= 2 0.102974833806812E+00 0.000000000000000E+00 z1= 3 0.193089376415778E-06 0.000000000000000E+00 alpha(00000058)=0.000000000000000E+00 beta (00000059)=0.130965228617389E+02 gamma(00000059)=0.130965228617389E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.14150E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 59 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000059)=0.000000000000000E+00 beta (00000060)=0.133653117317473E+02 gamma(00000060)=0.133653117317473E+02 lr_calc_dens: Charge drift due to real space implementation = -0.72591E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 60 z1= 1 -.523056409603567E-05 0.000000000000000E+00 z1= 2 -.943337712292842E-01 0.000000000000000E+00 z1= 3 -.141574767063450E-06 0.000000000000000E+00 alpha(00000060)=0.000000000000000E+00 beta (00000061)=0.130784870012601E+02 gamma(00000061)=0.130784870012601E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.20794E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 61 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000061)=0.000000000000000E+00 beta (00000062)=0.134065523853986E+02 gamma(00000062)=0.134065523853986E+02 lr_calc_dens: Charge drift due to real space implementation = 0.32044E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 62 z1= 1 0.643769459453790E-05 0.000000000000000E+00 z1= 2 0.857428359234713E-01 0.000000000000000E+00 z1= 3 0.313038346388886E-07 0.000000000000000E+00 alpha(00000062)=0.000000000000000E+00 beta (00000063)=0.129900441494067E+02 gamma(00000063)=0.129900441494067E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.81295E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 63 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000063)=0.000000000000000E+00 beta (00000064)=0.133678409455836E+02 gamma(00000064)=0.133678409455836E+02 lr_calc_dens: Charge drift due to real space implementation = -0.25917E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 64 z1= 1 -.700157278314337E-05 0.000000000000000E+00 z1= 2 -.773804559591467E-01 0.000000000000000E+00 z1= 3 -.304256105917479E-07 0.000000000000000E+00 alpha(00000064)=0.000000000000000E+00 beta (00000065)=0.130560689474008E+02 gamma(00000065)=0.130560689474008E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.46047E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 65 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000065)=0.000000000000000E+00 beta (00000066)=0.134453232254620E+02 gamma(00000066)=0.134453232254620E+02 lr_calc_dens: Charge drift due to real space implementation = 0.35987E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 66 z1= 1 0.787224505546802E-05 0.000000000000000E+00 z1= 2 0.697062923087005E-01 0.000000000000000E+00 z1= 3 0.724504436488379E-07 0.000000000000000E+00 alpha(00000066)=0.000000000000000E+00 beta (00000067)=0.131031779092030E+02 gamma(00000067)=0.131031779092030E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.33660E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 67 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000067)=0.000000000000000E+00 beta (00000068)=0.134381418515410E+02 gamma(00000068)=0.134381418515410E+02 lr_calc_dens: Charge drift due to real space implementation = -0.21311E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 68 z1= 1 -.737159976979540E-05 0.000000000000000E+00 z1= 2 -.630119624653174E-01 0.000000000000000E+00 z1= 3 -.228580619082476E-06 0.000000000000000E+00 alpha(00000068)=0.000000000000000E+00 beta (00000069)=0.131134439342662E+02 gamma(00000069)=0.131134439342662E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.38230E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 69 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000069)=0.000000000000000E+00 beta (00000070)=0.134316407397130E+02 gamma(00000070)=0.134316407397130E+02 lr_calc_dens: Charge drift due to real space implementation = -0.33609E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 70 z1= 1 0.790866935681395E-05 0.000000000000000E+00 z1= 2 0.570880787059228E-01 0.000000000000000E+00 z1= 3 0.373899064143427E-06 0.000000000000000E+00 alpha(00000070)=0.000000000000000E+00 beta (00000071)=0.130733585881672E+02 gamma(00000071)=0.130733585881672E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.86555E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 71 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000071)=0.000000000000000E+00 beta (00000072)=0.134418671319776E+02 gamma(00000072)=0.134418671319776E+02 lr_calc_dens: Charge drift due to real space implementation = -0.32065E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 72 z1= 1 -.832991054940113E-05 0.000000000000000E+00 z1= 2 -.515706526867423E-01 0.000000000000000E+00 z1= 3 -.439291206271968E-06 0.000000000000000E+00 alpha(00000072)=0.000000000000000E+00 beta (00000073)=0.130441362525302E+02 gamma(00000073)=0.130441362525302E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.86597E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 73 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000073)=0.000000000000000E+00 beta (00000074)=0.134549011334524E+02 gamma(00000074)=0.134549011334524E+02 lr_calc_dens: Charge drift due to real space implementation = 0.44883E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 74 z1= 1 0.785161263197436E-05 0.000000000000000E+00 z1= 2 0.464600508688018E-01 0.000000000000000E+00 z1= 3 0.237742441646587E-06 0.000000000000000E+00 alpha(00000074)=0.000000000000000E+00 beta (00000075)=0.130268136752454E+02 gamma(00000075)=0.130268136752454E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.82309E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 75 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000075)=0.000000000000000E+00 beta (00000076)=0.134978027618134E+02 gamma(00000076)=0.134978027618134E+02 lr_calc_dens: Charge drift due to real space implementation = -0.59152E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 76 z1= 1 -.777529018287579E-05 0.000000000000000E+00 z1= 2 -.416711357074125E-01 0.000000000000000E+00 z1= 3 -.626202376431203E-07 0.000000000000000E+00 alpha(00000076)=0.000000000000000E+00 beta (00000077)=0.131683211434468E+02 gamma(00000077)=0.131683211434468E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.57457E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 77 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000077)=0.000000000000000E+00 beta (00000078)=0.135304536676243E+02 gamma(00000078)=0.135304536676243E+02 lr_calc_dens: Charge drift due to real space implementation = 0.55631E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 78 z1= 1 0.801364146395082E-05 0.000000000000000E+00 z1= 2 0.376370138759250E-01 0.000000000000000E+00 z1= 3 -.139095391677322E-06 0.000000000000000E+00 alpha(00000078)=0.000000000000000E+00 beta (00000079)=0.131317125409589E+02 gamma(00000079)=0.131317125409589E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.45922E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 79 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000079)=0.000000000000000E+00 beta (00000080)=0.134541911738131E+02 gamma(00000080)=0.134541911738131E+02 lr_calc_dens: Charge drift due to real space implementation = -0.51716E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 80 z1= 1 -.704717310247120E-05 0.000000000000000E+00 z1= 2 -.339410352228807E-01 0.000000000000000E+00 z1= 3 0.243093501639731E-06 0.000000000000000E+00 alpha(00000080)=0.000000000000000E+00 beta (00000081)=0.130203632300754E+02 gamma(00000081)=0.130203632300754E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.36621E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 81 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000081)=0.000000000000000E+00 beta (00000082)=0.134988911433097E+02 gamma(00000082)=0.134988911433097E+02 lr_calc_dens: Charge drift due to real space implementation = 0.29433E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 82 z1= 1 0.670239331234876E-05 0.000000000000000E+00 z1= 2 0.300809285689616E-01 0.000000000000000E+00 z1= 3 -.334607755071509E-06 0.000000000000000E+00 alpha(00000082)=0.000000000000000E+00 beta (00000083)=0.130151319279998E+02 gamma(00000083)=0.130151319279998E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.53597E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 83 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000083)=0.000000000000000E+00 beta (00000084)=0.134884676828879E+02 gamma(00000084)=0.134884676828879E+02 lr_calc_dens: Charge drift due to real space implementation = -0.26286E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 84 z1= 1 -.611391742012454E-05 0.000000000000000E+00 z1= 2 -.265241099304462E-01 0.000000000000000E+00 z1= 3 0.377637539945929E-06 0.000000000000000E+00 alpha(00000084)=0.000000000000000E+00 beta (00000085)=0.129666972286519E+02 gamma(00000085)=0.129666972286519E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.78811E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 85 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000085)=0.000000000000000E+00 beta (00000086)=0.134162584137502E+02 gamma(00000086)=0.134162584137502E+02 lr_calc_dens: Charge drift due to real space implementation = 0.68485E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 86 z1= 1 0.549212074305201E-05 0.000000000000000E+00 z1= 2 0.232795754265371E-01 0.000000000000000E+00 z1= 3 -.415001422893952E-06 0.000000000000000E+00 alpha(00000086)=0.000000000000000E+00 beta (00000087)=0.129154935811231E+02 gamma(00000087)=0.129154935811231E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.46898E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 87 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000087)=0.000000000000000E+00 beta (00000088)=0.135638885620702E+02 gamma(00000088)=0.135638885620702E+02 lr_calc_dens: Charge drift due to real space implementation = -0.70648E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 88 z1= 1 -.493770667879534E-05 0.000000000000000E+00 z1= 2 -.198624879947569E-01 0.000000000000000E+00 z1= 3 0.342637420303768E-06 0.000000000000000E+00 alpha(00000088)=0.000000000000000E+00 beta (00000089)=0.130512530778819E+02 gamma(00000089)=0.130512530778819E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.26793E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 89 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000089)=0.000000000000000E+00 beta (00000090)=0.134795468827842E+02 gamma(00000090)=0.134795468827842E+02 lr_calc_dens: Charge drift due to real space implementation = 0.66039E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 90 z1= 1 0.471846558220117E-05 0.000000000000000E+00 z1= 2 0.169655408894217E-01 0.000000000000000E+00 z1= 3 -.144527336502793E-06 0.000000000000000E+00 alpha(00000090)=0.000000000000000E+00 beta (00000091)=0.130370521867542E+02 gamma(00000091)=0.130370521867542E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.62890E-10 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 91 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000091)=0.000000000000000E+00 beta (00000092)=0.135107024038771E+02 gamma(00000092)=0.135107024038771E+02 lr_calc_dens: Charge drift due to real space implementation = -0.19386E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 92 z1= 1 -.383152056086539E-05 0.000000000000000E+00 z1= 2 -.142835035551595E-01 0.000000000000000E+00 z1= 3 -.346518414139521E-06 0.000000000000000E+00 alpha(00000092)=0.000000000000000E+00 beta (00000093)=0.129165787201794E+02 gamma(00000093)=0.129165787201794E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.21246E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 93 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000093)=0.000000000000000E+00 beta (00000094)=0.135178008172047E+02 gamma(00000094)=0.135178008172047E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12239E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 94 z1= 1 0.311286967349641E-05 0.000000000000000E+00 z1= 2 0.116910019330443E-01 0.000000000000000E+00 z1= 3 0.851068287220443E-06 0.000000000000000E+00 alpha(00000094)=0.000000000000000E+00 beta (00000095)=0.129326378512444E+02 gamma(00000095)=0.129326378512444E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.89729E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 95 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000095)=0.000000000000000E+00 beta (00000096)=0.135032316220468E+02 gamma(00000096)=0.135032316220468E+02 lr_calc_dens: Charge drift due to real space implementation = -0.56802E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 96 z1= 1 -.261690584961840E-05 0.000000000000000E+00 z1= 2 -.931130605728235E-02 0.000000000000000E+00 z1= 3 -.110078670699884E-05 0.000000000000000E+00 alpha(00000096)=0.000000000000000E+00 beta (00000097)=0.130141990697465E+02 gamma(00000097)=0.130141990697465E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.71904E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 97 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000097)=0.000000000000000E+00 beta (00000098)=0.134920816652788E+02 gamma(00000098)=0.134920816652788E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10743E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 98 z1= 1 0.350727555791072E-05 0.000000000000000E+00 z1= 2 0.711601394285973E-02 0.000000000000000E+00 z1= 3 0.121141832276953E-05 0.000000000000000E+00 alpha(00000098)=0.000000000000000E+00 beta (00000099)=0.129250583582207E+02 gamma(00000099)=0.129250583582207E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.93814E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 99 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000099)=0.000000000000000E+00 beta (00000100)=0.135296730299734E+02 gamma(00000100)=0.135296730299734E+02 lr_calc_dens: Charge drift due to real space implementation = -0.95679E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 100 z1= 1 -.239590062643289E-05 0.000000000000000E+00 z1= 2 -.489903177501807E-02 0.000000000000000E+00 z1= 3 -.112417301623058E-05 0.000000000000000E+00 alpha(00000100)=0.000000000000000E+00 beta (00000101)=0.130354159818751E+02 gamma(00000101)=0.130354159818751E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.37474E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 101 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000101)=0.000000000000000E+00 beta (00000102)=0.135085807176319E+02 gamma(00000102)=0.135085807176319E+02 lr_calc_dens: Charge drift due to real space implementation = 0.44305E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 102 z1= 1 -.927860611503462E-07 0.000000000000000E+00 z1= 2 0.276462943720984E-02 0.000000000000000E+00 z1= 3 0.634942347414432E-06 0.000000000000000E+00 alpha(00000102)=0.000000000000000E+00 beta (00000103)=0.130026286817140E+02 gamma(00000103)=0.130026286817140E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.41566E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 103 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000103)=0.000000000000000E+00 beta (00000104)=0.135133584084468E+02 gamma(00000104)=0.135133584084468E+02 lr_calc_dens: Charge drift due to real space implementation = 0.34831E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 104 z1= 1 0.120080025964482E-05 0.000000000000000E+00 z1= 2 -.720143535689076E-03 0.000000000000000E+00 z1= 3 0.814298037727232E-07 0.000000000000000E+00 alpha(00000104)=0.000000000000000E+00 beta (00000105)=0.130409427379597E+02 gamma(00000105)=0.130409427379597E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.17008E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 105 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000105)=0.000000000000000E+00 beta (00000106)=0.135462359883199E+02 gamma(00000106)=0.135462359883199E+02 lr_calc_dens: Charge drift due to real space implementation = -0.32849E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 106 z1= 1 -.119340578403401E-05 0.000000000000000E+00 z1= 2 -.114031473099277E-02 0.000000000000000E+00 z1= 3 -.109185447621943E-05 0.000000000000000E+00 alpha(00000106)=0.000000000000000E+00 beta (00000107)=0.130255753326723E+02 gamma(00000107)=0.130255753326723E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.44309E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 107 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000107)=0.000000000000000E+00 beta (00000108)=0.135571632615485E+02 gamma(00000108)=0.135571632615485E+02 lr_calc_dens: Charge drift due to real space implementation = -0.66125E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 108 z1= 1 0.886099778881627E-06 0.000000000000000E+00 z1= 2 0.287968151627624E-02 0.000000000000000E+00 z1= 3 0.217466554261967E-05 0.000000000000000E+00 alpha(00000108)=0.000000000000000E+00 beta (00000109)=0.130224873133469E+02 gamma(00000109)=0.130224873133469E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.72524E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 109 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000109)=0.000000000000000E+00 beta (00000110)=0.134857138806931E+02 gamma(00000110)=0.134857138806931E+02 lr_calc_dens: Charge drift due to real space implementation = 0.77132E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 110 z1= 1 -.239681804274899E-05 0.000000000000000E+00 z1= 2 -.461916498059869E-02 0.000000000000000E+00 z1= 3 -.309185313938231E-05 0.000000000000000E+00 alpha(00000110)=0.000000000000000E+00 beta (00000111)=0.129691339206894E+02 gamma(00000111)=0.129691339206894E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.28483E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 111 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000111)=0.000000000000000E+00 beta (00000112)=0.135452120324439E+02 gamma(00000112)=0.135452120324439E+02 lr_calc_dens: Charge drift due to real space implementation = -0.94191E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 112 z1= 1 0.455368885246554E-05 0.000000000000000E+00 z1= 2 0.623529772681497E-02 0.000000000000000E+00 z1= 3 0.369291295627941E-05 0.000000000000000E+00 alpha(00000112)=0.000000000000000E+00 beta (00000113)=0.130205521770332E+02 gamma(00000113)=0.130205521770332E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.29083E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 113 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000113)=0.000000000000000E+00 beta (00000114)=0.135119078476375E+02 gamma(00000114)=0.135119078476375E+02 lr_calc_dens: Charge drift due to real space implementation = 0.63861E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 114 z1= 1 -.512410273546555E-05 0.000000000000000E+00 z1= 2 -.778982003327917E-02 0.000000000000000E+00 z1= 3 -.399519655493660E-05 0.000000000000000E+00 alpha(00000114)=0.000000000000000E+00 beta (00000115)=0.129502137358949E+02 gamma(00000115)=0.129502137358949E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.79598E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 115 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000115)=0.000000000000000E+00 beta (00000116)=0.135534736847469E+02 gamma(00000116)=0.135534736847469E+02 lr_calc_dens: Charge drift due to real space implementation = 0.35251E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 116 z1= 1 0.543642997832133E-05 0.000000000000000E+00 z1= 2 0.914085607863445E-02 0.000000000000000E+00 z1= 3 0.352403330550814E-05 0.000000000000000E+00 alpha(00000116)=0.000000000000000E+00 beta (00000117)=0.130006239046727E+02 gamma(00000117)=0.130006239046727E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.15446E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 117 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000117)=0.000000000000000E+00 beta (00000118)=0.136047580558692E+02 gamma(00000118)=0.136047580558692E+02 lr_calc_dens: Charge drift due to real space implementation = -0.51176E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 118 z1= 1 -.548020107076982E-05 0.000000000000000E+00 z1= 2 -.102647813312134E-01 0.000000000000000E+00 z1= 3 -.281837990252966E-05 0.000000000000000E+00 alpha(00000118)=0.000000000000000E+00 beta (00000119)=0.129948074229328E+02 gamma(00000119)=0.129948074229328E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.51197E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 119 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000119)=0.000000000000000E+00 beta (00000120)=0.135205964048673E+02 gamma(00000120)=0.135205964048673E+02 lr_calc_dens: Charge drift due to real space implementation = 0.57018E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 120 z1= 1 0.548798017917587E-05 0.000000000000000E+00 z1= 2 0.114121039392445E-01 0.000000000000000E+00 z1= 3 0.193652151442880E-05 0.000000000000000E+00 alpha(00000120)=0.000000000000000E+00 beta (00000121)=0.129462980808928E+02 gamma(00000121)=0.129462980808928E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.59710E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 121 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000121)=0.000000000000000E+00 beta (00000122)=0.134486134882709E+02 gamma(00000122)=0.134486134882709E+02 lr_calc_dens: Charge drift due to real space implementation = 0.24823E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 122 z1= 1 -.542563450180167E-05 0.000000000000000E+00 z1= 2 -.126728601847831E-01 0.000000000000000E+00 z1= 3 -.793274304473943E-06 0.000000000000000E+00 alpha(00000122)=0.000000000000000E+00 beta (00000123)=0.130249641725029E+02 gamma(00000123)=0.130249641725029E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.43943E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 123 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000123)=0.000000000000000E+00 beta (00000124)=0.134960520284835E+02 gamma(00000124)=0.134960520284835E+02 lr_calc_dens: Charge drift due to real space implementation = -0.29840E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 124 z1= 1 0.611032582293041E-05 0.000000000000000E+00 z1= 2 0.140475418196764E-01 0.000000000000000E+00 z1= 3 -.552814749530910E-06 0.000000000000000E+00 alpha(00000124)=0.000000000000000E+00 beta (00000125)=0.129952875351612E+02 gamma(00000125)=0.129952875351612E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.42541E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 125 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000125)=0.000000000000000E+00 beta (00000126)=0.135264165736958E+02 gamma(00000126)=0.135264165736958E+02 lr_calc_dens: Charge drift due to real space implementation = 0.50812E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 126 z1= 1 -.612408089048153E-05 0.000000000000000E+00 z1= 2 -.153922409225646E-01 0.000000000000000E+00 z1= 3 0.164107738316081E-05 0.000000000000000E+00 alpha(00000126)=0.000000000000000E+00 beta (00000127)=0.130182786363100E+02 gamma(00000127)=0.130182786363100E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.15474E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 127 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000127)=0.000000000000000E+00 beta (00000128)=0.135531978177282E+02 gamma(00000128)=0.135531978177282E+02 lr_calc_dens: Charge drift due to real space implementation = -0.39085E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 128 z1= 1 0.686340131995575E-05 0.000000000000000E+00 z1= 2 0.166005535646027E-01 0.000000000000000E+00 z1= 3 -.261780503373862E-05 0.000000000000000E+00 alpha(00000128)=0.000000000000000E+00 beta (00000129)=0.128629431808027E+02 gamma(00000129)=0.128629431808027E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.30196E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 129 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000129)=0.000000000000000E+00 beta (00000130)=0.136181446041351E+02 gamma(00000130)=0.136181446041351E+02 lr_calc_dens: Charge drift due to real space implementation = 0.20674E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 130 z1= 1 -.715710693509428E-05 0.000000000000000E+00 z1= 2 -.172979864991325E-01 0.000000000000000E+00 z1= 3 0.316867839972573E-05 0.000000000000000E+00 alpha(00000130)=0.000000000000000E+00 beta (00000131)=0.129809767059558E+02 gamma(00000131)=0.129809767059558E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.36924E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 131 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000131)=0.000000000000000E+00 beta (00000132)=0.136218860769822E+02 gamma(00000132)=0.136218860769822E+02 lr_calc_dens: Charge drift due to real space implementation = -0.71710E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 132 z1= 1 0.731586123724638E-05 0.000000000000000E+00 z1= 2 0.179546389410375E-01 0.000000000000000E+00 z1= 3 -.362834464273118E-05 0.000000000000000E+00 alpha(00000132)=0.000000000000000E+00 beta (00000133)=0.130603020303182E+02 gamma(00000133)=0.130603020303182E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.34316E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 133 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000133)=0.000000000000000E+00 beta (00000134)=0.135982363582361E+02 gamma(00000134)=0.135982363582361E+02 lr_calc_dens: Charge drift due to real space implementation = -0.97364E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 134 z1= 1 -.791192427750760E-05 0.000000000000000E+00 z1= 2 -.186570935115993E-01 0.000000000000000E+00 z1= 3 0.372928701598943E-05 0.000000000000000E+00 alpha(00000134)=0.000000000000000E+00 beta (00000135)=0.130062246230291E+02 gamma(00000135)=0.130062246230291E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.60081E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 135 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000135)=0.000000000000000E+00 beta (00000136)=0.134278337021571E+02 gamma(00000136)=0.134278337021571E+02 lr_calc_dens: Charge drift due to real space implementation = -0.38064E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 136 z1= 1 0.807738907561764E-05 0.000000000000000E+00 z1= 2 0.194710071204398E-01 0.000000000000000E+00 z1= 3 -.381095065719562E-05 0.000000000000000E+00 alpha(00000136)=0.000000000000000E+00 beta (00000137)=0.129760123176778E+02 gamma(00000137)=0.129760123176778E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.87502E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 137 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000137)=0.000000000000000E+00 beta (00000138)=0.134612667556309E+02 gamma(00000138)=0.134612667556309E+02 lr_calc_dens: Charge drift due to real space implementation = 0.40711E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 138 z1= 1 -.840312492286061E-05 0.000000000000000E+00 z1= 2 -.201024973648547E-01 0.000000000000000E+00 z1= 3 0.352309956831187E-05 0.000000000000000E+00 alpha(00000138)=0.000000000000000E+00 beta (00000139)=0.130099386028910E+02 gamma(00000139)=0.130099386028910E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.83733E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 139 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000139)=0.000000000000000E+00 beta (00000140)=0.136232483424613E+02 gamma(00000140)=0.136232483424613E+02 lr_calc_dens: Charge drift due to real space implementation = -0.84410E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 140 z1= 1 0.869607111970332E-05 0.000000000000000E+00 z1= 2 0.205072209797136E-01 0.000000000000000E+00 z1= 3 -.304017667127206E-05 0.000000000000000E+00 alpha(00000140)=0.000000000000000E+00 beta (00000141)=0.129869185112299E+02 gamma(00000141)=0.129869185112299E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14150E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 141 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000141)=0.000000000000000E+00 beta (00000142)=0.135301810331500E+02 gamma(00000142)=0.135301810331500E+02 lr_calc_dens: Charge drift due to real space implementation = 0.37461E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 142 z1= 1 -.919115841992342E-05 0.000000000000000E+00 z1= 2 -.211452007691914E-01 0.000000000000000E+00 z1= 3 0.196399470745940E-05 0.000000000000000E+00 alpha(00000142)=0.000000000000000E+00 beta (00000143)=0.129781725944965E+02 gamma(00000143)=0.129781725944965E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.31484E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 143 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000143)=0.000000000000000E+00 beta (00000144)=0.135440880695335E+02 gamma(00000144)=0.135440880695335E+02 lr_calc_dens: Charge drift due to real space implementation = 0.14904E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 144 z1= 1 0.898641032593631E-05 0.000000000000000E+00 z1= 2 0.218054740497008E-01 0.000000000000000E+00 z1= 3 -.756693944889041E-06 0.000000000000000E+00 alpha(00000144)=0.000000000000000E+00 beta (00000145)=0.129801708766775E+02 gamma(00000145)=0.129801708766775E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.71535E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 145 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000145)=0.000000000000000E+00 beta (00000146)=0.135930865292672E+02 gamma(00000146)=0.135930865292672E+02 lr_calc_dens: Charge drift due to real space implementation = 0.29497E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 146 z1= 1 -.888182034522456E-05 0.000000000000000E+00 z1= 2 -.223337265112075E-01 0.000000000000000E+00 z1= 3 -.655100899822719E-06 0.000000000000000E+00 alpha(00000146)=0.000000000000000E+00 beta (00000147)=0.128939077759722E+02 gamma(00000147)=0.128939077759722E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.86947E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 147 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000147)=0.000000000000000E+00 beta (00000148)=0.136730086404406E+02 gamma(00000148)=0.136730086404406E+02 lr_calc_dens: Charge drift due to real space implementation = -0.80355E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 148 z1= 1 0.924720534868119E-05 0.000000000000000E+00 z1= 2 0.224081381863658E-01 0.000000000000000E+00 z1= 3 0.204863893140154E-05 0.000000000000000E+00 alpha(00000148)=0.000000000000000E+00 beta (00000149)=0.129469879858534E+02 gamma(00000149)=0.129469879858534E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.51741E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 149 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000149)=0.000000000000000E+00 beta (00000150)=0.135159709679085E+02 gamma(00000150)=0.135159709679085E+02 lr_calc_dens: Charge drift due to real space implementation = 0.93256E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 150 z1= 1 -.930405512107949E-05 0.000000000000000E+00 z1= 2 -.226618832251073E-01 0.000000000000000E+00 z1= 3 -.303686410443424E-05 0.000000000000000E+00 alpha(00000150)=0.000000000000000E+00 beta (00000151)=0.129245825780644E+02 gamma(00000151)=0.129245825780644E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13556E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 151 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000151)=0.000000000000000E+00 beta (00000152)=0.135650918849107E+02 gamma(00000152)=0.135650918849107E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12723E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 152 z1= 1 0.100951671877982E-04 0.000000000000000E+00 z1= 2 0.226067117587677E-01 0.000000000000000E+00 z1= 3 0.370349187141560E-05 0.000000000000000E+00 alpha(00000152)=0.000000000000000E+00 beta (00000153)=0.129678532715053E+02 gamma(00000153)=0.129678532715053E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.18801E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 153 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000153)=0.000000000000000E+00 beta (00000154)=0.135678599573450E+02 gamma(00000154)=0.135678599573450E+02 lr_calc_dens: Charge drift due to real space implementation = -0.20213E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 154 z1= 1 -.117552634887105E-04 0.000000000000000E+00 z1= 2 -.224856175029401E-01 0.000000000000000E+00 z1= 3 -.423543516706502E-05 0.000000000000000E+00 alpha(00000154)=0.000000000000000E+00 beta (00000155)=0.130507417904843E+02 gamma(00000155)=0.130507417904843E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.82501E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 155 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000155)=0.000000000000000E+00 beta (00000156)=0.135038960209028E+02 gamma(00000156)=0.135038960209028E+02 lr_calc_dens: Charge drift due to real space implementation = -0.36408E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 156 z1= 1 0.108223519165711E-04 0.000000000000000E+00 z1= 2 0.225565055203909E-01 0.000000000000000E+00 z1= 3 0.474907032600465E-05 0.000000000000000E+00 alpha(00000156)=0.000000000000000E+00 beta (00000157)=0.129593951493289E+02 gamma(00000157)=0.129593951493289E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.65176E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 157 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000157)=0.000000000000000E+00 beta (00000158)=0.135816017389823E+02 gamma(00000158)=0.135816017389823E+02 lr_calc_dens: Charge drift due to real space implementation = 0.65785E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 158 z1= 1 -.906050805828161E-05 0.000000000000000E+00 z1= 2 -.224351811848553E-01 0.000000000000000E+00 z1= 3 -.489817947418083E-05 0.000000000000000E+00 alpha(00000158)=0.000000000000000E+00 beta (00000159)=0.129172871666008E+02 gamma(00000159)=0.129172871666008E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.18575E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 159 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000159)=0.000000000000000E+00 beta (00000160)=0.135063044660623E+02 gamma(00000160)=0.135063044660623E+02 lr_calc_dens: Charge drift due to real space implementation = -0.22610E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 160 z1= 1 0.784772798238798E-05 0.000000000000000E+00 z1= 2 0.225227228559345E-01 0.000000000000000E+00 z1= 3 0.481687700791985E-05 0.000000000000000E+00 alpha(00000160)=0.000000000000000E+00 beta (00000161)=0.129464504521647E+02 gamma(00000161)=0.129464504521647E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.67035E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 161 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000161)=0.000000000000000E+00 beta (00000162)=0.134978590757965E+02 gamma(00000162)=0.134978590757965E+02 lr_calc_dens: Charge drift due to real space implementation = 0.58199E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 162 z1= 1 -.740822931950390E-05 0.000000000000000E+00 z1= 2 -.226967669964778E-01 0.000000000000000E+00 z1= 3 -.446712383256326E-05 0.000000000000000E+00 alpha(00000162)=0.000000000000000E+00 beta (00000163)=0.129861864760703E+02 gamma(00000163)=0.129861864760703E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.92598E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 163 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000163)=0.000000000000000E+00 beta (00000164)=0.136189512413553E+02 gamma(00000164)=0.136189512413553E+02 lr_calc_dens: Charge drift due to real space implementation = -0.15608E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 164 z1= 1 0.775501563405213E-05 0.000000000000000E+00 z1= 2 0.226926087194950E-01 0.000000000000000E+00 z1= 3 0.408254748533792E-05 0.000000000000000E+00 alpha(00000164)=0.000000000000000E+00 beta (00000165)=0.129418410328116E+02 gamma(00000165)=0.129418410328116E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.55492E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 165 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000165)=0.000000000000000E+00 beta (00000166)=0.135005878446259E+02 gamma(00000166)=0.135005878446259E+02 lr_calc_dens: Charge drift due to real space implementation = 0.17322E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 166 z1= 1 -.659058788043693E-05 0.000000000000000E+00 z1= 2 -.226910186426796E-01 0.000000000000000E+00 z1= 3 -.386976906292117E-05 0.000000000000000E+00 alpha(00000166)=0.000000000000000E+00 beta (00000167)=0.128770920412119E+02 gamma(00000167)=0.128770920412119E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14682E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 167 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000167)=0.000000000000000E+00 beta (00000168)=0.135561605590888E+02 gamma(00000168)=0.135561605590888E+02 lr_calc_dens: Charge drift due to real space implementation = -0.48433E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 168 z1= 1 0.436125176407230E-05 0.000000000000000E+00 z1= 2 0.222953810510944E-01 0.000000000000000E+00 z1= 3 0.359269070397535E-05 0.000000000000000E+00 alpha(00000168)=0.000000000000000E+00 beta (00000169)=0.129963132658816E+02 gamma(00000169)=0.129963132658816E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.18748E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 169 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000169)=0.000000000000000E+00 beta (00000170)=0.136147184483702E+02 gamma(00000170)=0.136147184483702E+02 lr_calc_dens: Charge drift due to real space implementation = -0.13320E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 170 z1= 1 -.428094593895971E-05 0.000000000000000E+00 z1= 2 -.219062485991968E-01 0.000000000000000E+00 z1= 3 -.326478595692322E-05 0.000000000000000E+00 alpha(00000170)=0.000000000000000E+00 beta (00000171)=0.129372800185226E+02 gamma(00000171)=0.129372800185226E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.37564E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 171 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000171)=0.000000000000000E+00 beta (00000172)=0.135417076177901E+02 gamma(00000172)=0.135417076177901E+02 lr_calc_dens: Charge drift due to real space implementation = 0.15175E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 172 z1= 1 0.398171389760955E-05 0.000000000000000E+00 z1= 2 0.215308699214509E-01 0.000000000000000E+00 z1= 3 0.338815054932092E-05 0.000000000000000E+00 alpha(00000172)=0.000000000000000E+00 beta (00000173)=0.129202943456509E+02 gamma(00000173)=0.129202943456509E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.11602E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 173 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000173)=0.000000000000000E+00 beta (00000174)=0.135415681993749E+02 gamma(00000174)=0.135415681993749E+02 lr_calc_dens: Charge drift due to real space implementation = -0.38917E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 174 z1= 1 -.223502075091201E-05 0.000000000000000E+00 z1= 2 -.212227370890136E-01 0.000000000000000E+00 z1= 3 -.382434983411755E-05 0.000000000000000E+00 alpha(00000174)=0.000000000000000E+00 beta (00000175)=0.130491303448727E+02 gamma(00000175)=0.130491303448727E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.15535E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 175 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000175)=0.000000000000000E+00 beta (00000176)=0.136448746714218E+02 gamma(00000176)=0.136448746714218E+02 lr_calc_dens: Charge drift due to real space implementation = -0.73810E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 176 z1= 1 0.176639591475090E-05 0.000000000000000E+00 z1= 2 0.210647267869394E-01 0.000000000000000E+00 z1= 3 0.463684560824742E-05 0.000000000000000E+00 alpha(00000176)=0.000000000000000E+00 beta (00000177)=0.129419050425658E+02 gamma(00000177)=0.129419050425658E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12205E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 177 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000177)=0.000000000000000E+00 beta (00000178)=0.135601580311566E+02 gamma(00000178)=0.135601580311566E+02 lr_calc_dens: Charge drift due to real space implementation = 0.13797E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 178 z1= 1 -.140960248099821E-05 0.000000000000000E+00 z1= 2 -.207968027536148E-01 0.000000000000000E+00 z1= 3 -.564469367608576E-05 0.000000000000000E+00 alpha(00000178)=0.000000000000000E+00 beta (00000179)=0.128894565284261E+02 gamma(00000179)=0.128894565284261E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.66679E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 179 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000179)=0.000000000000000E+00 beta (00000180)=0.135116634115888E+02 gamma(00000180)=0.135116634115888E+02 lr_calc_dens: Charge drift due to real space implementation = -0.18028E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 180 z1= 1 -.592082654155002E-07 0.000000000000000E+00 z1= 2 0.203023146053643E-01 0.000000000000000E+00 z1= 3 0.681292524355898E-05 0.000000000000000E+00 alpha(00000180)=0.000000000000000E+00 beta (00000181)=0.128972759134448E+02 gamma(00000181)=0.128972759134448E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.42663E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 181 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000181)=0.000000000000000E+00 beta (00000182)=0.136342538044699E+02 gamma(00000182)=0.136342538044699E+02 lr_calc_dens: Charge drift due to real space implementation = 0.15144E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 182 z1= 1 0.129667287157922E-05 0.000000000000000E+00 z1= 2 -.194413446775839E-01 0.000000000000000E+00 z1= 3 -.796183825082538E-05 0.000000000000000E+00 alpha(00000182)=0.000000000000000E+00 beta (00000183)=0.130271477695639E+02 gamma(00000183)=0.130271477695639E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.15447E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 183 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000183)=0.000000000000000E+00 beta (00000184)=0.136078561013323E+02 gamma(00000184)=0.136078561013323E+02 lr_calc_dens: Charge drift due to real space implementation = -0.34886E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 184 z1= 1 -.204238777723985E-05 0.000000000000000E+00 z1= 2 0.187621847285767E-01 0.000000000000000E+00 z1= 3 0.924154858638315E-05 0.000000000000000E+00 alpha(00000184)=0.000000000000000E+00 beta (00000185)=0.129392405163151E+02 gamma(00000185)=0.129392405163151E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.15498E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 185 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000185)=0.000000000000000E+00 beta (00000186)=0.135414585063845E+02 gamma(00000186)=0.135414585063845E+02 lr_calc_dens: Charge drift due to real space implementation = -0.34049E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 186 z1= 1 0.203283966095525E-05 0.000000000000000E+00 z1= 2 -.180976516934822E-01 0.000000000000000E+00 z1= 3 -.989182459349916E-05 0.000000000000000E+00 alpha(00000186)=0.000000000000000E+00 beta (00000187)=0.129102683933022E+02 gamma(00000187)=0.129102683933022E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13748E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 187 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000187)=0.000000000000000E+00 beta (00000188)=0.135465449965901E+02 gamma(00000188)=0.135465449965901E+02 lr_calc_dens: Charge drift due to real space implementation = 0.98150E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 188 z1= 1 -.193622140445479E-05 0.000000000000000E+00 z1= 2 0.173237550232051E-01 0.000000000000000E+00 z1= 3 0.107174501172185E-04 0.000000000000000E+00 alpha(00000188)=0.000000000000000E+00 beta (00000189)=0.129583989920470E+02 gamma(00000189)=0.129583989920470E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.78000E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 189 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000189)=0.000000000000000E+00 beta (00000190)=0.135193497764861E+02 gamma(00000190)=0.135193497764861E+02 lr_calc_dens: Charge drift due to real space implementation = -0.14363E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 190 z1= 1 0.362403244672741E-05 0.000000000000000E+00 z1= 2 -.165722978735257E-01 0.000000000000000E+00 z1= 3 -.111882156015801E-04 0.000000000000000E+00 alpha(00000190)=0.000000000000000E+00 beta (00000191)=0.129195024256050E+02 gamma(00000191)=0.129195024256050E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.64098E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 191 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000191)=0.000000000000000E+00 beta (00000192)=0.135273377451205E+02 gamma(00000192)=0.135273377451205E+02 lr_calc_dens: Charge drift due to real space implementation = 0.31658E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 192 z1= 1 -.569437039281764E-05 0.000000000000000E+00 z1= 2 0.157749677836939E-01 0.000000000000000E+00 z1= 3 0.113200032904264E-04 0.000000000000000E+00 alpha(00000192)=0.000000000000000E+00 beta (00000193)=0.129682860842087E+02 gamma(00000193)=0.129682860842087E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.66449E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 193 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000193)=0.000000000000000E+00 beta (00000194)=0.135889744894592E+02 gamma(00000194)=0.135889744894592E+02 lr_calc_dens: Charge drift due to real space implementation = 0.31554E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 194 z1= 1 0.805520340549544E-05 0.000000000000000E+00 z1= 2 -.150875523899715E-01 0.000000000000000E+00 z1= 3 -.110492605336010E-04 0.000000000000000E+00 alpha(00000194)=0.000000000000000E+00 beta (00000195)=0.129893914510196E+02 gamma(00000195)=0.129893914510196E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.22865E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 195 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000195)=0.000000000000000E+00 beta (00000196)=0.135396383696310E+02 gamma(00000196)=0.135396383696310E+02 lr_calc_dens: Charge drift due to real space implementation = -0.17694E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 196 z1= 1 -.771499871329330E-05 0.000000000000000E+00 z1= 2 0.145786000324829E-01 0.000000000000000E+00 z1= 3 0.109008814678951E-04 0.000000000000000E+00 alpha(00000196)=0.000000000000000E+00 beta (00000197)=0.129617103311521E+02 gamma(00000197)=0.129617103311521E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.21493E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 197 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000197)=0.000000000000000E+00 beta (00000198)=0.135699306350179E+02 gamma(00000198)=0.135699306350179E+02 lr_calc_dens: Charge drift due to real space implementation = 0.60334E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 198 z1= 1 0.558376663941946E-05 0.000000000000000E+00 z1= 2 -.139937190818630E-01 0.000000000000000E+00 z1= 3 -.105334776850976E-04 0.000000000000000E+00 alpha(00000198)=0.000000000000000E+00 beta (00000199)=0.129893237750610E+02 gamma(00000199)=0.129893237750610E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.18242E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 199 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000199)=0.000000000000000E+00 beta (00000200)=0.135548811251822E+02 gamma(00000200)=0.135548811251822E+02 lr_calc_dens: Charge drift due to real space implementation = 0.34965E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 200 z1= 1 -.310205891886767E-05 0.000000000000000E+00 z1= 2 0.134511928523174E-01 0.000000000000000E+00 z1= 3 0.987314180537056E-05 0.000000000000000E+00 alpha(00000200)=0.000000000000000E+00 beta (00000201)=0.129435836608087E+02 gamma(00000201)=0.129435836608087E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.84913E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 201 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000201)=0.000000000000000E+00 beta (00000202)=0.136257576783043E+02 gamma(00000202)=0.136257576783043E+02 lr_calc_dens: Charge drift due to real space implementation = 0.19375E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 202 z1= 1 0.414898335941109E-05 0.000000000000000E+00 z1= 2 -.126998750493583E-01 0.000000000000000E+00 z1= 3 -.951290407187519E-05 0.000000000000000E+00 alpha(00000202)=0.000000000000000E+00 beta (00000203)=0.128720009582357E+02 gamma(00000203)=0.128720009582357E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.94451E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 203 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000203)=0.000000000000000E+00 beta (00000204)=0.136371259269670E+02 gamma(00000204)=0.136371259269670E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10446E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 204 z1= 1 -.610589671783471E-05 0.000000000000000E+00 z1= 2 0.119433969609648E-01 0.000000000000000E+00 z1= 3 0.914878788023700E-05 0.000000000000000E+00 alpha(00000204)=0.000000000000000E+00 beta (00000205)=0.130310247067593E+02 gamma(00000205)=0.130310247067593E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.56688E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 205 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000205)=0.000000000000000E+00 beta (00000206)=0.135647365329490E+02 gamma(00000206)=0.135647365329490E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11009E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 206 z1= 1 0.696872456517044E-05 0.000000000000000E+00 z1= 2 -.114774601971646E-01 0.000000000000000E+00 z1= 3 -.905466974744116E-05 0.000000000000000E+00 alpha(00000206)=0.000000000000000E+00 beta (00000207)=0.130280600308639E+02 gamma(00000207)=0.130280600308639E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.97975E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 207 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000207)=0.000000000000000E+00 beta (00000208)=0.135813666859603E+02 gamma(00000208)=0.135813666859603E+02 lr_calc_dens: Charge drift due to real space implementation = -0.17010E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 208 z1= 1 -.650620436428405E-05 0.000000000000000E+00 z1= 2 0.109600592037292E-01 0.000000000000000E+00 z1= 3 0.934989021030353E-05 0.000000000000000E+00 alpha(00000208)=0.000000000000000E+00 beta (00000209)=0.129543432942778E+02 gamma(00000209)=0.129543432942778E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10233E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 209 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000209)=0.000000000000000E+00 beta (00000210)=0.135854905013074E+02 gamma(00000210)=0.135854905013074E+02 lr_calc_dens: Charge drift due to real space implementation = -0.65655E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 210 z1= 1 0.597742072148445E-05 0.000000000000000E+00 z1= 2 -.103291305025529E-01 0.000000000000000E+00 z1= 3 -.998656352195044E-05 0.000000000000000E+00 alpha(00000210)=0.000000000000000E+00 beta (00000211)=0.129430134005755E+02 gamma(00000211)=0.129430134005755E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.23005E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 211 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000211)=0.000000000000000E+00 beta (00000212)=0.135843902640836E+02 gamma(00000212)=0.135843902640836E+02 lr_calc_dens: Charge drift due to real space implementation = 0.49052E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 212 z1= 1 -.622698916181129E-05 0.000000000000000E+00 z1= 2 0.961430640801484E-02 0.000000000000000E+00 z1= 3 0.107671087570156E-04 0.000000000000000E+00 alpha(00000212)=0.000000000000000E+00 beta (00000213)=0.129218025717786E+02 gamma(00000213)=0.129218025717786E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.75741E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 213 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000213)=0.000000000000000E+00 beta (00000214)=0.134358624213064E+02 gamma(00000214)=0.134358624213064E+02 lr_calc_dens: Charge drift due to real space implementation = -0.74036E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 214 z1= 1 0.715774588402190E-05 0.000000000000000E+00 z1= 2 -.897737339450599E-02 0.000000000000000E+00 z1= 3 -.114888799689152E-04 0.000000000000000E+00 alpha(00000214)=0.000000000000000E+00 beta (00000215)=0.130155016316691E+02 gamma(00000215)=0.130155016316691E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.64595E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 215 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000215)=0.000000000000000E+00 beta (00000216)=0.136097015790657E+02 gamma(00000216)=0.136097015790657E+02 lr_calc_dens: Charge drift due to real space implementation = 0.25713E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 216 z1= 1 -.567276045278448E-05 0.000000000000000E+00 z1= 2 0.835686275521579E-02 0.000000000000000E+00 z1= 3 0.121232522716062E-04 0.000000000000000E+00 alpha(00000216)=0.000000000000000E+00 beta (00000217)=0.129543906544904E+02 gamma(00000217)=0.129543906544904E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.92435E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 217 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000217)=0.000000000000000E+00 beta (00000218)=0.135254533763920E+02 gamma(00000218)=0.135254533763920E+02 lr_calc_dens: Charge drift due to real space implementation = 0.39193E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 218 z1= 1 0.308955984340597E-05 0.000000000000000E+00 z1= 2 -.778067808167535E-02 0.000000000000000E+00 z1= 3 -.124710649522179E-04 0.000000000000000E+00 alpha(00000218)=0.000000000000000E+00 beta (00000219)=0.129649429372193E+02 gamma(00000219)=0.129649429372193E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.55771E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 219 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000219)=0.000000000000000E+00 beta (00000220)=0.136029255033765E+02 gamma(00000220)=0.136029255033765E+02 lr_calc_dens: Charge drift due to real space implementation = -0.60211E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 220 z1= 1 -.256769578907239E-05 0.000000000000000E+00 z1= 2 0.719980548894960E-02 0.000000000000000E+00 z1= 3 0.130809547292941E-04 0.000000000000000E+00 alpha(00000220)=0.000000000000000E+00 beta (00000221)=0.129040472901341E+02 gamma(00000221)=0.129040472901341E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10754E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 221 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000221)=0.000000000000000E+00 beta (00000222)=0.136211205447651E+02 gamma(00000222)=0.136211205447651E+02 lr_calc_dens: Charge drift due to real space implementation = 0.67948E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 222 z1= 1 0.265102170192346E-05 0.000000000000000E+00 z1= 2 -.665678295778012E-02 0.000000000000000E+00 z1= 3 -.131526182198808E-04 0.000000000000000E+00 alpha(00000222)=0.000000000000000E+00 beta (00000223)=0.129831938080992E+02 gamma(00000223)=0.129831938080992E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.65512E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 223 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000223)=0.000000000000000E+00 beta (00000224)=0.134491095552519E+02 gamma(00000224)=0.134491095552519E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10390E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 224 z1= 1 -.277536559801150E-05 0.000000000000000E+00 z1= 2 0.637465191124179E-02 0.000000000000000E+00 z1= 3 0.134488382896662E-04 0.000000000000000E+00 alpha(00000224)=0.000000000000000E+00 beta (00000225)=0.129564680382891E+02 gamma(00000225)=0.129564680382891E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.45894E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 225 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000225)=0.000000000000000E+00 beta (00000226)=0.136684751474478E+02 gamma(00000226)=0.136684751474478E+02 lr_calc_dens: Charge drift due to real space implementation = -0.51939E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 226 z1= 1 0.289868018859369E-05 0.000000000000000E+00 z1= 2 -.615048133650021E-02 0.000000000000000E+00 z1= 3 -.129915853709725E-04 0.000000000000000E+00 alpha(00000226)=0.000000000000000E+00 beta (00000227)=0.129667961185304E+02 gamma(00000227)=0.129667961185304E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.14652E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 227 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000227)=0.000000000000000E+00 beta (00000228)=0.135335841820039E+02 gamma(00000228)=0.135335841820039E+02 lr_calc_dens: Charge drift due to real space implementation = 0.70436E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 228 z1= 1 -.184800956088294E-05 0.000000000000000E+00 z1= 2 0.603982159746010E-02 0.000000000000000E+00 z1= 3 0.123240916539420E-04 0.000000000000000E+00 alpha(00000228)=0.000000000000000E+00 beta (00000229)=0.129868868006973E+02 gamma(00000229)=0.129868868006973E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.92754E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 229 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000229)=0.000000000000000E+00 beta (00000230)=0.136030372182037E+02 gamma(00000230)=0.136030372182037E+02 lr_calc_dens: Charge drift due to real space implementation = 0.46486E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 230 z1= 1 0.855483535930172E-06 0.000000000000000E+00 z1= 2 -.581858566415699E-02 0.000000000000000E+00 z1= 3 -.112670094388070E-04 0.000000000000000E+00 alpha(00000230)=0.000000000000000E+00 beta (00000231)=0.128902185096288E+02 gamma(00000231)=0.128902185096288E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11264E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 231 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000231)=0.000000000000000E+00 beta (00000232)=0.135339921520549E+02 gamma(00000232)=0.135339921520549E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10253E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 232 z1= 1 -.102118075226074E-05 0.000000000000000E+00 z1= 2 0.547235782444818E-02 0.000000000000000E+00 z1= 3 0.101921450771680E-04 0.000000000000000E+00 alpha(00000232)=0.000000000000000E+00 beta (00000233)=0.129586017908641E+02 gamma(00000233)=0.129586017908641E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.11405E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 233 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000233)=0.000000000000000E+00 beta (00000234)=0.135491940294940E+02 gamma(00000234)=0.135491940294940E+02 lr_calc_dens: Charge drift due to real space implementation = 0.73487E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 234 z1= 1 -.296659474967147E-06 0.000000000000000E+00 z1= 2 -.512023366020592E-02 0.000000000000000E+00 z1= 3 -.907257681815896E-05 0.000000000000000E+00 alpha(00000234)=0.000000000000000E+00 beta (00000235)=0.130585506228269E+02 gamma(00000235)=0.130585506228269E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.43876E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 235 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000235)=0.000000000000000E+00 beta (00000236)=0.135268942574107E+02 gamma(00000236)=0.135268942574107E+02 lr_calc_dens: Charge drift due to real space implementation = -0.71671E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 236 z1= 1 0.164945216305813E-05 0.000000000000000E+00 z1= 2 0.482639995391378E-02 0.000000000000000E+00 z1= 3 0.800941530431902E-05 0.000000000000000E+00 alpha(00000236)=0.000000000000000E+00 beta (00000237)=0.129506596774695E+02 gamma(00000237)=0.129506596774695E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.41909E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 237 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000237)=0.000000000000000E+00 beta (00000238)=0.135927423481213E+02 gamma(00000238)=0.135927423481213E+02 lr_calc_dens: Charge drift due to real space implementation = -0.50285E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 238 z1= 1 -.396386506754196E-05 0.000000000000000E+00 z1= 2 -.452212664168405E-02 0.000000000000000E+00 z1= 3 -.716720240256713E-05 0.000000000000000E+00 alpha(00000238)=0.000000000000000E+00 beta (00000239)=0.130355023879849E+02 gamma(00000239)=0.130355023879849E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.25666E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 239 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000239)=0.000000000000000E+00 beta (00000240)=0.135783085429176E+02 gamma(00000240)=0.135783085429176E+02 lr_calc_dens: Charge drift due to real space implementation = 0.14600E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 240 z1= 1 0.542393670074481E-05 0.000000000000000E+00 z1= 2 0.432917316646140E-02 0.000000000000000E+00 z1= 3 0.639114208643284E-05 0.000000000000000E+00 alpha(00000240)=0.000000000000000E+00 beta (00000241)=0.130206031490435E+02 gamma(00000241)=0.130206031490435E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.51603E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 241 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000241)=0.000000000000000E+00 beta (00000242)=0.134819775702385E+02 gamma(00000242)=0.134819775702385E+02 lr_calc_dens: Charge drift due to real space implementation = 0.53495E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 242 z1= 1 -.576336726761193E-05 0.000000000000000E+00 z1= 2 -.417584821362116E-02 0.000000000000000E+00 z1= 3 -.587554578943925E-05 0.000000000000000E+00 alpha(00000242)=0.000000000000000E+00 beta (00000243)=0.130302588332868E+02 gamma(00000243)=0.130302588332868E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10429E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 243 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000243)=0.000000000000000E+00 beta (00000244)=0.134330783396608E+02 gamma(00000244)=0.134330783396608E+02 lr_calc_dens: Charge drift due to real space implementation = -0.15027E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 244 z1= 1 0.620437242631125E-05 0.000000000000000E+00 z1= 2 0.408978263123893E-02 0.000000000000000E+00 z1= 3 0.576831755618112E-05 0.000000000000000E+00 alpha(00000244)=0.000000000000000E+00 beta (00000245)=0.130000655113558E+02 gamma(00000245)=0.130000655113558E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.16481E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 245 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000245)=0.000000000000000E+00 beta (00000246)=0.136273500176073E+02 gamma(00000246)=0.136273500176073E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10147E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 246 z1= 1 -.569734338746563E-05 0.000000000000000E+00 z1= 2 -.397676855824167E-02 0.000000000000000E+00 z1= 3 -.583311688202325E-05 0.000000000000000E+00 alpha(00000246)=0.000000000000000E+00 beta (00000247)=0.130402515640975E+02 gamma(00000247)=0.130402515640975E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.48171E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 247 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000247)=0.000000000000000E+00 beta (00000248)=0.134596744627732E+02 gamma(00000248)=0.134596744627732E+02 lr_calc_dens: Charge drift due to real space implementation = -0.38598E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 248 z1= 1 0.547246780934147E-05 0.000000000000000E+00 z1= 2 0.384249961411426E-02 0.000000000000000E+00 z1= 3 0.596967215329498E-05 0.000000000000000E+00 alpha(00000248)=0.000000000000000E+00 beta (00000249)=0.130244339754055E+02 gamma(00000249)=0.130244339754055E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.44286E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 249 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000249)=0.000000000000000E+00 beta (00000250)=0.134947387501838E+02 gamma(00000250)=0.134947387501838E+02 lr_calc_dens: Charge drift due to real space implementation = 0.87786E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 250 z1= 1 -.402990376878899E-05 0.000000000000000E+00 z1= 2 -.353259742119140E-02 0.000000000000000E+00 z1= 3 -.615325500459818E-05 0.000000000000000E+00 alpha(00000250)=0.000000000000000E+00 beta (00000251)=0.130043333634439E+02 gamma(00000251)=0.130043333634439E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.75648E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 251 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000251)=0.000000000000000E+00 beta (00000252)=0.135232304265423E+02 gamma(00000252)=0.135232304265423E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10317E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 252 z1= 1 0.241260820095263E-05 0.000000000000000E+00 z1= 2 0.312792819798777E-02 0.000000000000000E+00 z1= 3 0.605481357390263E-05 0.000000000000000E+00 alpha(00000252)=0.000000000000000E+00 beta (00000253)=0.128568103074454E+02 gamma(00000253)=0.128568103074454E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10827E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 253 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000253)=0.000000000000000E+00 beta (00000254)=0.134847221258387E+02 gamma(00000254)=0.134847221258387E+02 lr_calc_dens: Charge drift due to real space implementation = 0.17316E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 254 z1= 1 -.318855919498057E-05 0.000000000000000E+00 z1= 2 -.274862178155338E-02 0.000000000000000E+00 z1= 3 -.593155615877969E-05 0.000000000000000E+00 alpha(00000254)=0.000000000000000E+00 beta (00000255)=0.130755588508265E+02 gamma(00000255)=0.130755588508265E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13263E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 255 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000255)=0.000000000000000E+00 beta (00000256)=0.135334259162653E+02 gamma(00000256)=0.135334259162653E+02 lr_calc_dens: Charge drift due to real space implementation = 0.87961E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 256 z1= 1 0.529638910303594E-05 0.000000000000000E+00 z1= 2 0.244797939607350E-02 0.000000000000000E+00 z1= 3 0.578292858644051E-05 0.000000000000000E+00 alpha(00000256)=0.000000000000000E+00 beta (00000257)=0.129336390507115E+02 gamma(00000257)=0.129336390507115E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.49516E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 257 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000257)=0.000000000000000E+00 beta (00000258)=0.135025030872717E+02 gamma(00000258)=0.135025030872717E+02 lr_calc_dens: Charge drift due to real space implementation = -0.87918E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 258 z1= 1 -.553046056882018E-05 0.000000000000000E+00 z1= 2 -.211813926986438E-02 0.000000000000000E+00 z1= 3 -.574393167210974E-05 0.000000000000000E+00 alpha(00000258)=0.000000000000000E+00 beta (00000259)=0.129904346641133E+02 gamma(00000259)=0.129904346641133E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.89938E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 259 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000259)=0.000000000000000E+00 beta (00000260)=0.135857207543334E+02 gamma(00000260)=0.135857207543334E+02 lr_calc_dens: Charge drift due to real space implementation = 0.47479E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 260 z1= 1 0.454046022186553E-05 0.000000000000000E+00 z1= 2 0.171568803857509E-02 0.000000000000000E+00 z1= 3 0.566383455770785E-05 0.000000000000000E+00 alpha(00000260)=0.000000000000000E+00 beta (00000261)=0.129210237968226E+02 gamma(00000261)=0.129210237968226E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.24550E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 261 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000261)=0.000000000000000E+00 beta (00000262)=0.134595025767755E+02 gamma(00000262)=0.134595025767755E+02 lr_calc_dens: Charge drift due to real space implementation = -0.35221E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 262 z1= 1 -.470707907205040E-05 0.000000000000000E+00 z1= 2 -.125658732826156E-02 0.000000000000000E+00 z1= 3 -.590681548320195E-05 0.000000000000000E+00 alpha(00000262)=0.000000000000000E+00 beta (00000263)=0.128863726944667E+02 gamma(00000263)=0.128863726944667E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.47996E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 263 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000263)=0.000000000000000E+00 beta (00000264)=0.135289366283760E+02 gamma(00000264)=0.135289366283760E+02 lr_calc_dens: Charge drift due to real space implementation = 0.42858E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 264 z1= 1 0.532608824498949E-05 0.000000000000000E+00 z1= 2 0.686809088260559E-03 0.000000000000000E+00 z1= 3 0.644019194287471E-05 0.000000000000000E+00 alpha(00000264)=0.000000000000000E+00 beta (00000265)=0.130023318863287E+02 gamma(00000265)=0.130023318863287E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12289E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 265 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000265)=0.000000000000000E+00 beta (00000266)=0.135205781110567E+02 gamma(00000266)=0.135205781110567E+02 lr_calc_dens: Charge drift due to real space implementation = 0.35565E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 266 z1= 1 -.425981395295023E-05 0.000000000000000E+00 z1= 2 -.315677059364336E-04 0.000000000000000E+00 z1= 3 -.741675733346308E-05 0.000000000000000E+00 alpha(00000266)=0.000000000000000E+00 beta (00000267)=0.129494758392320E+02 gamma(00000267)=0.129494758392320E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12646E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 267 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000267)=0.000000000000000E+00 beta (00000268)=0.135627999152041E+02 gamma(00000268)=0.135627999152041E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12423E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 268 z1= 1 0.491711401630563E-05 0.000000000000000E+00 z1= 2 -.490987135923642E-03 0.000000000000000E+00 z1= 3 0.822992992561233E-05 0.000000000000000E+00 alpha(00000268)=0.000000000000000E+00 beta (00000269)=0.129691701189851E+02 gamma(00000269)=0.129691701189851E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.47185E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 269 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000269)=0.000000000000000E+00 beta (00000270)=0.135607049244426E+02 gamma(00000270)=0.135607049244426E+02 lr_calc_dens: Charge drift due to real space implementation = 0.15320E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 270 z1= 1 -.655772674806182E-05 0.000000000000000E+00 z1= 2 0.858760104461299E-03 0.000000000000000E+00 z1= 3 -.922359529719630E-05 0.000000000000000E+00 alpha(00000270)=0.000000000000000E+00 beta (00000271)=0.129641948922537E+02 gamma(00000271)=0.129641948922537E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.73160E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 271 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000271)=0.000000000000000E+00 beta (00000272)=0.135264748863952E+02 gamma(00000272)=0.135264748863952E+02 lr_calc_dens: Charge drift due to real space implementation = -0.73515E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 272 z1= 1 0.874764406371656E-05 0.000000000000000E+00 z1= 2 -.114084416487064E-02 0.000000000000000E+00 z1= 3 0.952764586634420E-05 0.000000000000000E+00 alpha(00000272)=0.000000000000000E+00 beta (00000273)=0.130502616225413E+02 gamma(00000273)=0.130502616225413E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12056E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 273 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000273)=0.000000000000000E+00 beta (00000274)=0.134557575123725E+02 gamma(00000274)=0.134557575123725E+02 lr_calc_dens: Charge drift due to real space implementation = -0.31315E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 274 z1= 1 -.103597994529068E-04 0.000000000000000E+00 z1= 2 0.135785675808080E-02 0.000000000000000E+00 z1= 3 -.100545920677983E-04 0.000000000000000E+00 alpha(00000274)=0.000000000000000E+00 beta (00000275)=0.129280287227282E+02 gamma(00000275)=0.129280287227282E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.72906E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 275 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000275)=0.000000000000000E+00 beta (00000276)=0.135557563820300E+02 gamma(00000276)=0.135557563820300E+02 lr_calc_dens: Charge drift due to real space implementation = 0.48891E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 276 z1= 1 0.117523945433679E-04 0.000000000000000E+00 z1= 2 -.148230226082723E-02 0.000000000000000E+00 z1= 3 0.992803930745242E-05 0.000000000000000E+00 alpha(00000276)=0.000000000000000E+00 beta (00000277)=0.130750527379029E+02 gamma(00000277)=0.130750527379029E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.54477E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 277 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000277)=0.000000000000000E+00 beta (00000278)=0.135351115787115E+02 gamma(00000278)=0.135351115787115E+02 lr_calc_dens: Charge drift due to real space implementation = -0.67394E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 278 z1= 1 -.126800102376763E-04 0.000000000000000E+00 z1= 2 0.162187336287589E-02 0.000000000000000E+00 z1= 3 -.102723286710613E-04 0.000000000000000E+00 alpha(00000278)=0.000000000000000E+00 beta (00000279)=0.130980581369621E+02 gamma(00000279)=0.130980581369621E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.86871E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 279 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000279)=0.000000000000000E+00 beta (00000280)=0.135245517725071E+02 gamma(00000280)=0.135245517725071E+02 lr_calc_dens: Charge drift due to real space implementation = 0.49394E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 280 z1= 1 0.123120644568444E-04 0.000000000000000E+00 z1= 2 -.186886373150440E-02 0.000000000000000E+00 z1= 3 0.102363161020290E-04 0.000000000000000E+00 alpha(00000280)=0.000000000000000E+00 beta (00000281)=0.129544652995341E+02 gamma(00000281)=0.129544652995341E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.41453E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 281 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000281)=0.000000000000000E+00 beta (00000282)=0.136073566311200E+02 gamma(00000282)=0.136073566311200E+02 lr_calc_dens: Charge drift due to real space implementation = 0.20660E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 282 z1= 1 -.112822128012519E-04 0.000000000000000E+00 z1= 2 0.213679796702918E-02 0.000000000000000E+00 z1= 3 -.100523985063328E-04 0.000000000000000E+00 alpha(00000282)=0.000000000000000E+00 beta (00000283)=0.130150264184774E+02 gamma(00000283)=0.130150264184774E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11313E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 283 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000283)=0.000000000000000E+00 beta (00000284)=0.135547693825455E+02 gamma(00000284)=0.135547693825455E+02 lr_calc_dens: Charge drift due to real space implementation = -0.31571E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 284 z1= 1 0.122022679203602E-04 0.000000000000000E+00 z1= 2 -.243706599647093E-02 0.000000000000000E+00 z1= 3 0.990528423230970E-05 0.000000000000000E+00 alpha(00000284)=0.000000000000000E+00 beta (00000285)=0.129592706459045E+02 gamma(00000285)=0.129592706459045E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.25521E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 285 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000285)=0.000000000000000E+00 beta (00000286)=0.135282812487351E+02 gamma(00000286)=0.135282812487351E+02 lr_calc_dens: Charge drift due to real space implementation = -0.19696E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 286 z1= 1 -.129999976415931E-04 0.000000000000000E+00 z1= 2 0.265710356944971E-02 0.000000000000000E+00 z1= 3 -.104171821424369E-04 0.000000000000000E+00 alpha(00000286)=0.000000000000000E+00 beta (00000287)=0.129989312639812E+02 gamma(00000287)=0.129989312639812E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.13083E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 287 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000287)=0.000000000000000E+00 beta (00000288)=0.134913140677074E+02 gamma(00000288)=0.134913140677074E+02 lr_calc_dens: Charge drift due to real space implementation = 0.22407E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 288 z1= 1 0.136691174646522E-04 0.000000000000000E+00 z1= 2 -.283396771152024E-02 0.000000000000000E+00 z1= 3 0.111815807356153E-04 0.000000000000000E+00 alpha(00000288)=0.000000000000000E+00 beta (00000289)=0.130585628820079E+02 gamma(00000289)=0.130585628820079E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.28007E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 289 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000289)=0.000000000000000E+00 beta (00000290)=0.134900567836261E+02 gamma(00000290)=0.134900567836261E+02 lr_calc_dens: Charge drift due to real space implementation = -0.47240E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 290 z1= 1 -.145142204893115E-04 0.000000000000000E+00 z1= 2 0.296948240461131E-02 0.000000000000000E+00 z1= 3 -.126365667295002E-04 0.000000000000000E+00 alpha(00000290)=0.000000000000000E+00 beta (00000291)=0.129594913329672E+02 gamma(00000291)=0.129594913329672E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.84411E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 291 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000291)=0.000000000000000E+00 beta (00000292)=0.135158417661442E+02 gamma(00000292)=0.135158417661442E+02 lr_calc_dens: Charge drift due to real space implementation = 0.16162E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 292 z1= 1 0.153117203459141E-04 0.000000000000000E+00 z1= 2 -.294881271123339E-02 0.000000000000000E+00 z1= 3 0.140663024398631E-04 0.000000000000000E+00 alpha(00000292)=0.000000000000000E+00 beta (00000293)=0.130265595753615E+02 gamma(00000293)=0.130265595753615E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13082E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 293 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000293)=0.000000000000000E+00 beta (00000294)=0.135239555291080E+02 gamma(00000294)=0.135239555291080E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10071E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 294 z1= 1 -.138320019269691E-04 0.000000000000000E+00 z1= 2 0.293413295211788E-02 0.000000000000000E+00 z1= 3 -.152317621713049E-04 0.000000000000000E+00 alpha(00000294)=0.000000000000000E+00 beta (00000295)=0.129411969325335E+02 gamma(00000295)=0.129411969325335E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.25124E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 295 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000295)=0.000000000000000E+00 beta (00000296)=0.134868931230044E+02 gamma(00000296)=0.134868931230044E+02 lr_calc_dens: Charge drift due to real space implementation = -0.81980E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 296 z1= 1 0.118171251490486E-04 0.000000000000000E+00 z1= 2 -.302658310486979E-02 0.000000000000000E+00 z1= 3 0.156716021468776E-04 0.000000000000000E+00 alpha(00000296)=0.000000000000000E+00 beta (00000297)=0.129630463111797E+02 gamma(00000297)=0.129630463111797E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.20071E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 297 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000297)=0.000000000000000E+00 beta (00000298)=0.134892065132477E+02 gamma(00000298)=0.134892065132477E+02 lr_calc_dens: Charge drift due to real space implementation = 0.51819E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 298 z1= 1 -.103101329213154E-04 0.000000000000000E+00 z1= 2 0.324196974732862E-02 0.000000000000000E+00 z1= 3 -.159234511058306E-04 0.000000000000000E+00 alpha(00000298)=0.000000000000000E+00 beta (00000299)=0.129319313107273E+02 gamma(00000299)=0.129319313107273E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.42268E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 299 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000299)=0.000000000000000E+00 beta (00000300)=0.134598771664774E+02 gamma(00000300)=0.134598771664774E+02 lr_calc_dens: Charge drift due to real space implementation = -0.13458E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 300 z1= 1 0.982952124857061E-05 0.000000000000000E+00 z1= 2 -.347672215900263E-02 0.000000000000000E+00 z1= 3 0.151449349177243E-04 0.000000000000000E+00 alpha(00000300)=0.000000000000000E+00 beta (00000301)=0.129812307914537E+02 gamma(00000301)=0.129812307914537E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.49208E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 301 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000301)=0.000000000000000E+00 beta (00000302)=0.134445255036319E+02 gamma(00000302)=0.134445255036319E+02 lr_calc_dens: Charge drift due to real space implementation = -0.47890E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 302 z1= 1 -.110544841713787E-04 0.000000000000000E+00 z1= 2 0.369712954852176E-02 0.000000000000000E+00 z1= 3 -.143754829527636E-04 0.000000000000000E+00 alpha(00000302)=0.000000000000000E+00 beta (00000303)=0.130721203610637E+02 gamma(00000303)=0.130721203610637E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.18020E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 303 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000303)=0.000000000000000E+00 beta (00000304)=0.135176952021457E+02 gamma(00000304)=0.135176952021457E+02 lr_calc_dens: Charge drift due to real space implementation = 0.38835E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 304 z1= 1 0.122196329296058E-04 0.000000000000000E+00 z1= 2 -.391052360686472E-02 0.000000000000000E+00 z1= 3 0.135247068450118E-04 0.000000000000000E+00 alpha(00000304)=0.000000000000000E+00 beta (00000305)=0.130459492380198E+02 gamma(00000305)=0.130459492380198E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.70863E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 305 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000305)=0.000000000000000E+00 beta (00000306)=0.135017957497190E+02 gamma(00000306)=0.135017957497190E+02 lr_calc_dens: Charge drift due to real space implementation = 0.19075E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 306 z1= 1 -.112648609134260E-04 0.000000000000000E+00 z1= 2 0.394414264231733E-02 0.000000000000000E+00 z1= 3 -.129649600571343E-04 0.000000000000000E+00 alpha(00000306)=0.000000000000000E+00 beta (00000307)=0.130778569384785E+02 gamma(00000307)=0.130778569384785E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.63921E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 307 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000307)=0.000000000000000E+00 beta (00000308)=0.134699734273037E+02 gamma(00000308)=0.134699734273037E+02 lr_calc_dens: Charge drift due to real space implementation = -0.74198E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 308 z1= 1 0.865070793554549E-05 0.000000000000000E+00 z1= 2 -.383162108817505E-02 0.000000000000000E+00 z1= 3 0.123136529804500E-04 0.000000000000000E+00 alpha(00000308)=0.000000000000000E+00 beta (00000309)=0.129599714806903E+02 gamma(00000309)=0.129599714806903E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.26861E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 309 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000309)=0.000000000000000E+00 beta (00000310)=0.134464880599157E+02 gamma(00000310)=0.134464880599157E+02 lr_calc_dens: Charge drift due to real space implementation = 0.70337E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 310 z1= 1 -.549604417677402E-05 0.000000000000000E+00 z1= 2 0.357721572808294E-02 0.000000000000000E+00 z1= 3 -.117535880456711E-04 0.000000000000000E+00 alpha(00000310)=0.000000000000000E+00 beta (00000311)=0.130642287448048E+02 gamma(00000311)=0.130642287448048E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.43668E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 311 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000311)=0.000000000000000E+00 beta (00000312)=0.134951398648757E+02 gamma(00000312)=0.134951398648757E+02 lr_calc_dens: Charge drift due to real space implementation = -0.30581E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 312 z1= 1 0.372972991926224E-05 0.000000000000000E+00 z1= 2 -.332820112828335E-02 0.000000000000000E+00 z1= 3 0.113892428169364E-04 0.000000000000000E+00 alpha(00000312)=0.000000000000000E+00 beta (00000313)=0.130965007261848E+02 gamma(00000313)=0.130965007261848E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.36575E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 313 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000313)=0.000000000000000E+00 beta (00000314)=0.135116427177638E+02 gamma(00000314)=0.135116427177638E+02 lr_calc_dens: Charge drift due to real space implementation = 0.19542E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 314 z1= 1 -.243901618131488E-05 0.000000000000000E+00 z1= 2 0.315168591245060E-02 0.000000000000000E+00 z1= 3 -.109738586996580E-04 0.000000000000000E+00 alpha(00000314)=0.000000000000000E+00 beta (00000315)=0.130317629319552E+02 gamma(00000315)=0.130317629319552E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.11528E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 315 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000315)=0.000000000000000E+00 beta (00000316)=0.134162867050302E+02 gamma(00000316)=0.134162867050302E+02 lr_calc_dens: Charge drift due to real space implementation = -0.64287E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 316 z1= 1 -.772855822696143E-06 0.000000000000000E+00 z1= 2 -.308588387915375E-02 0.000000000000000E+00 z1= 3 0.104407870736367E-04 0.000000000000000E+00 alpha(00000316)=0.000000000000000E+00 beta (00000317)=0.129840391539621E+02 gamma(00000317)=0.129840391539621E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.54472E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 317 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000317)=0.000000000000000E+00 beta (00000318)=0.135380649260870E+02 gamma(00000318)=0.135380649260870E+02 lr_calc_dens: Charge drift due to real space implementation = 0.59493E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 318 z1= 1 0.423715081593031E-05 0.000000000000000E+00 z1= 2 0.300844804121232E-02 0.000000000000000E+00 z1= 3 -.100961905584925E-04 0.000000000000000E+00 alpha(00000318)=0.000000000000000E+00 beta (00000319)=0.129489826146435E+02 gamma(00000319)=0.129489826146435E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10980E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 319 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000319)=0.000000000000000E+00 beta (00000320)=0.134786564107674E+02 gamma(00000320)=0.134786564107674E+02 lr_calc_dens: Charge drift due to real space implementation = 0.14768E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 320 z1= 1 -.829934622281975E-05 0.000000000000000E+00 z1= 2 -.293488485023618E-02 0.000000000000000E+00 z1= 3 0.964827088826072E-05 0.000000000000000E+00 alpha(00000320)=0.000000000000000E+00 beta (00000321)=0.130506018254900E+02 gamma(00000321)=0.130506018254900E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.88506E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 321 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000321)=0.000000000000000E+00 beta (00000322)=0.135213514487788E+02 gamma(00000322)=0.135213514487788E+02 lr_calc_dens: Charge drift due to real space implementation = -0.58794E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 322 z1= 1 0.102239471766103E-04 0.000000000000000E+00 z1= 2 0.291465068148999E-02 0.000000000000000E+00 z1= 3 -.917826210126400E-05 0.000000000000000E+00 alpha(00000322)=0.000000000000000E+00 beta (00000323)=0.130368728005008E+02 gamma(00000323)=0.130368728005008E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.29743E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 323 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000323)=0.000000000000000E+00 beta (00000324)=0.135881968224484E+02 gamma(00000324)=0.135881968224484E+02 lr_calc_dens: Charge drift due to real space implementation = 0.37741E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 324 z1= 1 -.117032842204923E-04 0.000000000000000E+00 z1= 2 -.286447300153413E-02 0.000000000000000E+00 z1= 3 0.820921678358712E-05 0.000000000000000E+00 alpha(00000324)=0.000000000000000E+00 beta (00000325)=0.128558676440092E+02 gamma(00000325)=0.128558676440092E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.24882E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 325 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000325)=0.000000000000000E+00 beta (00000326)=0.135187467099595E+02 gamma(00000326)=0.135187467099595E+02 lr_calc_dens: Charge drift due to real space implementation = -0.46146E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 326 z1= 1 0.127628338478976E-04 0.000000000000000E+00 z1= 2 0.279364481433718E-02 0.000000000000000E+00 z1= 3 -.699464982992386E-05 0.000000000000000E+00 alpha(00000326)=0.000000000000000E+00 beta (00000327)=0.130564277053474E+02 gamma(00000327)=0.130564277053474E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12691E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 327 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000327)=0.000000000000000E+00 beta (00000328)=0.135513617856472E+02 gamma(00000328)=0.135513617856472E+02 lr_calc_dens: Charge drift due to real space implementation = 0.59166E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 328 z1= 1 -.143304522152200E-04 0.000000000000000E+00 z1= 2 -.277694033031949E-02 0.000000000000000E+00 z1= 3 0.514235615336050E-05 0.000000000000000E+00 alpha(00000328)=0.000000000000000E+00 beta (00000329)=0.130467916210865E+02 gamma(00000329)=0.130467916210865E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.27943E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 329 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000329)=0.000000000000000E+00 beta (00000330)=0.134644002654799E+02 gamma(00000330)=0.134644002654799E+02 lr_calc_dens: Charge drift due to real space implementation = -0.36674E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 330 z1= 1 0.179305340789675E-04 0.000000000000000E+00 z1= 2 0.279880843153525E-02 0.000000000000000E+00 z1= 3 -.356972338914105E-05 0.000000000000000E+00 alpha(00000330)=0.000000000000000E+00 beta (00000331)=0.129939439478239E+02 gamma(00000331)=0.129939439478239E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.92873E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 331 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000331)=0.000000000000000E+00 beta (00000332)=0.134365519474827E+02 gamma(00000332)=0.134365519474827E+02 lr_calc_dens: Charge drift due to real space implementation = -0.90994E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 332 z1= 1 -.221920997567962E-04 0.000000000000000E+00 z1= 2 -.284380407110138E-02 0.000000000000000E+00 z1= 3 0.160662457075380E-05 0.000000000000000E+00 alpha(00000332)=0.000000000000000E+00 beta (00000333)=0.130405211166443E+02 gamma(00000333)=0.130405211166443E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.35772E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 333 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000333)=0.000000000000000E+00 beta (00000334)=0.134782483530585E+02 gamma(00000334)=0.134782483530585E+02 lr_calc_dens: Charge drift due to real space implementation = 0.18184E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 334 z1= 1 0.240006046441574E-04 0.000000000000000E+00 z1= 2 0.300441173034528E-02 0.000000000000000E+00 z1= 3 0.167737226268928E-06 0.000000000000000E+00 alpha(00000334)=0.000000000000000E+00 beta (00000335)=0.130795730848881E+02 gamma(00000335)=0.130795730848881E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14778E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 335 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000335)=0.000000000000000E+00 beta (00000336)=0.134244978991029E+02 gamma(00000336)=0.134244978991029E+02 lr_calc_dens: Charge drift due to real space implementation = -0.46803E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 336 z1= 1 -.257318233508612E-04 0.000000000000000E+00 z1= 2 -.331511172332839E-02 0.000000000000000E+00 z1= 3 -.215364391480357E-05 0.000000000000000E+00 alpha(00000336)=0.000000000000000E+00 beta (00000337)=0.131104563949642E+02 gamma(00000337)=0.131104563949642E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.15837E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 337 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000337)=0.000000000000000E+00 beta (00000338)=0.135025444199806E+02 gamma(00000338)=0.135025444199806E+02 lr_calc_dens: Charge drift due to real space implementation = -0.58100E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 338 z1= 1 0.268993652698308E-04 0.000000000000000E+00 z1= 2 0.370798579280526E-02 0.000000000000000E+00 z1= 3 0.349939171120758E-05 0.000000000000000E+00 alpha(00000338)=0.000000000000000E+00 beta (00000339)=0.130527073552497E+02 gamma(00000339)=0.130527073552497E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.94449E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 339 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000339)=0.000000000000000E+00 beta (00000340)=0.134190603218877E+02 gamma(00000340)=0.134190603218877E+02 lr_calc_dens: Charge drift due to real space implementation = 0.97059E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 340 z1= 1 -.253406234836986E-04 0.000000000000000E+00 z1= 2 -.418671532393692E-02 0.000000000000000E+00 z1= 3 -.460546936217360E-05 0.000000000000000E+00 alpha(00000340)=0.000000000000000E+00 beta (00000341)=0.129994496219611E+02 gamma(00000341)=0.129994496219611E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.13118E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 341 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000341)=0.000000000000000E+00 beta (00000342)=0.133934454636115E+02 gamma(00000342)=0.133934454636115E+02 lr_calc_dens: Charge drift due to real space implementation = -0.61040E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 342 z1= 1 0.237109959915977E-04 0.000000000000000E+00 z1= 2 0.459704827421230E-02 0.000000000000000E+00 z1= 3 0.524184591876246E-05 0.000000000000000E+00 alpha(00000342)=0.000000000000000E+00 beta (00000343)=0.130295827221904E+02 gamma(00000343)=0.130295827221904E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.14190E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 343 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000343)=0.000000000000000E+00 beta (00000344)=0.135134168034873E+02 gamma(00000344)=0.135134168034873E+02 lr_calc_dens: Charge drift due to real space implementation = 0.73072E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 344 z1= 1 -.258855129898756E-04 0.000000000000000E+00 z1= 2 -.475501494729023E-02 0.000000000000000E+00 z1= 3 -.597566657594908E-05 0.000000000000000E+00 alpha(00000344)=0.000000000000000E+00 beta (00000345)=0.130405046258581E+02 gamma(00000345)=0.130405046258581E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.30946E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 345 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000345)=0.000000000000000E+00 beta (00000346)=0.135066853237453E+02 gamma(00000346)=0.135066853237453E+02 lr_calc_dens: Charge drift due to real space implementation = -0.31744E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 346 z1= 1 0.274889061059782E-04 0.000000000000000E+00 z1= 2 0.480117727191705E-02 0.000000000000000E+00 z1= 3 0.649293966620552E-05 0.000000000000000E+00 alpha(00000346)=0.000000000000000E+00 beta (00000347)=0.130455288984330E+02 gamma(00000347)=0.130455288984330E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.36561E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 347 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000347)=0.000000000000000E+00 beta (00000348)=0.134869952991947E+02 gamma(00000348)=0.134869952991947E+02 lr_calc_dens: Charge drift due to real space implementation = 0.86430E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 348 z1= 1 -.280293934416888E-04 0.000000000000000E+00 z1= 2 -.498317977613325E-02 0.000000000000000E+00 z1= 3 -.722196531006655E-05 0.000000000000000E+00 alpha(00000348)=0.000000000000000E+00 beta (00000349)=0.131043411810405E+02 gamma(00000349)=0.131043411810405E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.49674E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 349 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000349)=0.000000000000000E+00 beta (00000350)=0.134745090163219E+02 gamma(00000350)=0.134745090163219E+02 lr_calc_dens: Charge drift due to real space implementation = -0.31713E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 350 z1= 1 0.295285035984264E-04 0.000000000000000E+00 z1= 2 0.532006034597752E-02 0.000000000000000E+00 z1= 3 0.757113999587088E-05 0.000000000000000E+00 alpha(00000350)=0.000000000000000E+00 beta (00000351)=0.130475339150653E+02 gamma(00000351)=0.130475339150653E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.71491E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 351 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000351)=0.000000000000000E+00 beta (00000352)=0.134796163007026E+02 gamma(00000352)=0.134796163007026E+02 lr_calc_dens: Charge drift due to real space implementation = -0.34986E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 352 z1= 1 -.303106361307572E-04 0.000000000000000E+00 z1= 2 -.559085318050829E-02 0.000000000000000E+00 z1= 3 -.723533180736387E-05 0.000000000000000E+00 alpha(00000352)=0.000000000000000E+00 beta (00000353)=0.129844534745796E+02 gamma(00000353)=0.129844534745796E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.30283E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 353 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000353)=0.000000000000000E+00 beta (00000354)=0.135597285255179E+02 gamma(00000354)=0.135597285255179E+02 lr_calc_dens: Charge drift due to real space implementation = 0.33578E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 354 z1= 1 0.295278064888717E-04 0.000000000000000E+00 z1= 2 0.581076419531065E-02 0.000000000000000E+00 z1= 3 0.620870374664863E-05 0.000000000000000E+00 alpha(00000354)=0.000000000000000E+00 beta (00000355)=0.130204829908709E+02 gamma(00000355)=0.130204829908709E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.30585E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 355 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000355)=0.000000000000000E+00 beta (00000356)=0.135467394127974E+02 gamma(00000356)=0.135467394127974E+02 lr_calc_dens: Charge drift due to real space implementation = -0.62359E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 356 z1= 1 -.276037228146980E-04 0.000000000000000E+00 z1= 2 -.604811000854216E-02 0.000000000000000E+00 z1= 3 -.490143333796991E-05 0.000000000000000E+00 alpha(00000356)=0.000000000000000E+00 beta (00000357)=0.130233258299531E+02 gamma(00000357)=0.130233258299531E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.70407E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 357 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000357)=0.000000000000000E+00 beta (00000358)=0.133936289041511E+02 gamma(00000358)=0.133936289041511E+02 lr_calc_dens: Charge drift due to real space implementation = 0.67463E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 358 z1= 1 0.296326295639196E-04 0.000000000000000E+00 z1= 2 0.629399688025912E-02 0.000000000000000E+00 z1= 3 0.417072720487215E-05 0.000000000000000E+00 alpha(00000358)=0.000000000000000E+00 beta (00000359)=0.130782941441952E+02 gamma(00000359)=0.130782941441952E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.64614E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 359 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000359)=0.000000000000000E+00 beta (00000360)=0.134536451606150E+02 gamma(00000360)=0.134536451606150E+02 lr_calc_dens: Charge drift due to real space implementation = -0.15937E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 360 z1= 1 -.318536954702136E-04 0.000000000000000E+00 z1= 2 -.651979148373681E-02 0.000000000000000E+00 z1= 3 -.385446404268997E-05 0.000000000000000E+00 alpha(00000360)=0.000000000000000E+00 beta (00000361)=0.129555053767481E+02 gamma(00000361)=0.129555053767481E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.75234E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 361 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000361)=0.000000000000000E+00 beta (00000362)=0.134535065459501E+02 gamma(00000362)=0.134535065459501E+02 lr_calc_dens: Charge drift due to real space implementation = -0.30920E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 362 z1= 1 0.335020257436558E-04 0.000000000000000E+00 z1= 2 0.671038022175266E-02 0.000000000000000E+00 z1= 3 0.364828371722585E-05 0.000000000000000E+00 alpha(00000362)=0.000000000000000E+00 beta (00000363)=0.129751919687124E+02 gamma(00000363)=0.129751919687124E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.72485E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 363 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000363)=0.000000000000000E+00 beta (00000364)=0.134831249378727E+02 gamma(00000364)=0.134831249378727E+02 lr_calc_dens: Charge drift due to real space implementation = 0.94158E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 364 z1= 1 -.340003678603741E-04 0.000000000000000E+00 z1= 2 -.682666457428582E-02 0.000000000000000E+00 z1= 3 -.272914218809508E-05 0.000000000000000E+00 alpha(00000364)=0.000000000000000E+00 beta (00000365)=0.129997265880015E+02 gamma(00000365)=0.129997265880015E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.27856E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 365 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000365)=0.000000000000000E+00 beta (00000366)=0.134389164401520E+02 gamma(00000366)=0.134389164401520E+02 lr_calc_dens: Charge drift due to real space implementation = -0.90911E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 366 z1= 1 0.336817515497329E-04 0.000000000000000E+00 z1= 2 0.691786610959898E-02 0.000000000000000E+00 z1= 3 0.184081414261884E-05 0.000000000000000E+00 alpha(00000366)=0.000000000000000E+00 beta (00000367)=0.130149662348200E+02 gamma(00000367)=0.130149662348200E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.84451E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 367 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000367)=0.000000000000000E+00 beta (00000368)=0.135451381438498E+02 gamma(00000368)=0.135451381438498E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12065E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 368 z1= 1 -.330647520849531E-04 0.000000000000000E+00 z1= 2 -.692130402037848E-02 0.000000000000000E+00 z1= 3 -.521656709490160E-06 0.000000000000000E+00 alpha(00000368)=0.000000000000000E+00 beta (00000369)=0.129799326540900E+02 gamma(00000369)=0.129799326540900E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.59251E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 369 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000369)=0.000000000000000E+00 beta (00000370)=0.134742368411775E+02 gamma(00000370)=0.134742368411775E+02 lr_calc_dens: Charge drift due to real space implementation = 0.61588E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 370 z1= 1 0.322536694554495E-04 0.000000000000000E+00 z1= 2 0.683509308158621E-02 0.000000000000000E+00 z1= 3 -.238743037905911E-06 0.000000000000000E+00 alpha(00000370)=0.000000000000000E+00 beta (00000371)=0.130401130870209E+02 gamma(00000371)=0.130401130870209E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.37458E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 371 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000371)=0.000000000000000E+00 beta (00000372)=0.134928010814510E+02 gamma(00000372)=0.134928010814510E+02 lr_calc_dens: Charge drift due to real space implementation = -0.57123E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 372 z1= 1 -.330255416776276E-04 0.000000000000000E+00 z1= 2 -.666464668793867E-02 0.000000000000000E+00 z1= 3 0.654356036494820E-06 0.000000000000000E+00 alpha(00000372)=0.000000000000000E+00 beta (00000373)=0.129771275046418E+02 gamma(00000373)=0.129771275046418E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.47283E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 373 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000373)=0.000000000000000E+00 beta (00000374)=0.134022972974143E+02 gamma(00000374)=0.134022972974143E+02 lr_calc_dens: Charge drift due to real space implementation = 0.53898E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 374 z1= 1 0.325474309364252E-04 0.000000000000000E+00 z1= 2 0.664533142220985E-02 0.000000000000000E+00 z1= 3 -.412365949026739E-06 0.000000000000000E+00 alpha(00000374)=0.000000000000000E+00 beta (00000375)=0.130402644682114E+02 gamma(00000375)=0.130402644682114E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.55459E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 375 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000375)=0.000000000000000E+00 beta (00000376)=0.135301279896629E+02 gamma(00000376)=0.135301279896629E+02 lr_calc_dens: Charge drift due to real space implementation = 0.60743E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 376 z1= 1 -.313816140054266E-04 0.000000000000000E+00 z1= 2 -.673118461963490E-02 0.000000000000000E+00 z1= 3 0.702633307609576E-06 0.000000000000000E+00 alpha(00000376)=0.000000000000000E+00 beta (00000377)=0.129521110294642E+02 gamma(00000377)=0.129521110294642E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13493E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 377 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000377)=0.000000000000000E+00 beta (00000378)=0.134438923805312E+02 gamma(00000378)=0.134438923805312E+02 lr_calc_dens: Charge drift due to real space implementation = -0.58016E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 378 z1= 1 0.313852791177095E-04 0.000000000000000E+00 z1= 2 0.693152174183091E-02 0.000000000000000E+00 z1= 3 -.126830730633372E-05 0.000000000000000E+00 alpha(00000378)=0.000000000000000E+00 beta (00000379)=0.130754787642603E+02 gamma(00000379)=0.130754787642603E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.93480E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 379 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000379)=0.000000000000000E+00 beta (00000380)=0.135429755506995E+02 gamma(00000380)=0.135429755506995E+02 lr_calc_dens: Charge drift due to real space implementation = -0.29731E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 380 z1= 1 -.335661132768554E-04 0.000000000000000E+00 z1= 2 -.720814017333479E-02 0.000000000000000E+00 z1= 3 0.227206903211106E-05 0.000000000000000E+00 alpha(00000380)=0.000000000000000E+00 beta (00000381)=0.129521581670583E+02 gamma(00000381)=0.129521581670583E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.97806E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 381 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000381)=0.000000000000000E+00 beta (00000382)=0.135291204300513E+02 gamma(00000382)=0.135291204300513E+02 lr_calc_dens: Charge drift due to real space implementation = 0.14822E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 382 z1= 1 0.350726998491549E-04 0.000000000000000E+00 z1= 2 0.739098400713305E-02 0.000000000000000E+00 z1= 3 -.205056011833187E-05 0.000000000000000E+00 alpha(00000382)=0.000000000000000E+00 beta (00000383)=0.130538952965977E+02 gamma(00000383)=0.130538952965977E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.49129E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 383 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000383)=0.000000000000000E+00 beta (00000384)=0.134984847288867E+02 gamma(00000384)=0.134984847288867E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12290E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 384 z1= 1 -.355644225682912E-04 0.000000000000000E+00 z1= 2 -.767759363757591E-02 0.000000000000000E+00 z1= 3 0.236933686267766E-05 0.000000000000000E+00 alpha(00000384)=0.000000000000000E+00 beta (00000385)=0.130769692975902E+02 gamma(00000385)=0.130769692975902E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.18979E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 385 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000385)=0.000000000000000E+00 beta (00000386)=0.135160135637991E+02 gamma(00000386)=0.135160135637991E+02 lr_calc_dens: Charge drift due to real space implementation = -0.51739E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 386 z1= 1 0.350298030848926E-04 0.000000000000000E+00 z1= 2 0.812697382924696E-02 0.000000000000000E+00 z1= 3 -.329867664649411E-05 0.000000000000000E+00 alpha(00000386)=0.000000000000000E+00 beta (00000387)=0.130410047910647E+02 gamma(00000387)=0.130410047910647E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12872E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 387 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000387)=0.000000000000000E+00 beta (00000388)=0.134725204873991E+02 gamma(00000388)=0.134725204873991E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12658E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 388 z1= 1 -.361864893799173E-04 0.000000000000000E+00 z1= 2 -.875107348896699E-02 0.000000000000000E+00 z1= 3 0.468750367565241E-05 0.000000000000000E+00 alpha(00000388)=0.000000000000000E+00 beta (00000389)=0.130605037189048E+02 gamma(00000389)=0.130605037189048E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12668E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 389 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000389)=0.000000000000000E+00 beta (00000390)=0.135385658597458E+02 gamma(00000390)=0.135385658597458E+02 lr_calc_dens: Charge drift due to real space implementation = -0.86197E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 390 z1= 1 0.364359936901888E-04 0.000000000000000E+00 z1= 2 0.932526273202428E-02 0.000000000000000E+00 z1= 3 -.534668651435062E-05 0.000000000000000E+00 alpha(00000390)=0.000000000000000E+00 beta (00000391)=0.130911628089513E+02 gamma(00000391)=0.130911628089513E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.41242E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 391 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000391)=0.000000000000000E+00 beta (00000392)=0.134468510233568E+02 gamma(00000392)=0.134468510233568E+02 lr_calc_dens: Charge drift due to real space implementation = 0.32972E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 392 z1= 1 -.364855531328609E-04 0.000000000000000E+00 z1= 2 -.974540300432343E-02 0.000000000000000E+00 z1= 3 0.539686439290123E-05 0.000000000000000E+00 alpha(00000392)=0.000000000000000E+00 beta (00000393)=0.130328603671706E+02 gamma(00000393)=0.130328603671706E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.50106E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 393 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000393)=0.000000000000000E+00 beta (00000394)=0.134875290535675E+02 gamma(00000394)=0.134875290535675E+02 lr_calc_dens: Charge drift due to real space implementation = -0.60859E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 394 z1= 1 0.375996412101702E-04 0.000000000000000E+00 z1= 2 0.990041624851195E-02 0.000000000000000E+00 z1= 3 -.454922242206670E-05 0.000000000000000E+00 alpha(00000394)=0.000000000000000E+00 beta (00000395)=0.130409232051914E+02 gamma(00000395)=0.130409232051914E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.53296E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 395 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000395)=0.000000000000000E+00 beta (00000396)=0.134503216698817E+02 gamma(00000396)=0.134503216698817E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12406E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 396 z1= 1 -.388633075235154E-04 0.000000000000000E+00 z1= 2 -.100554273532711E-01 0.000000000000000E+00 z1= 3 0.337683137124569E-05 0.000000000000000E+00 alpha(00000396)=0.000000000000000E+00 beta (00000397)=0.130212444721506E+02 gamma(00000397)=0.130212444721506E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.73896E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 397 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000397)=0.000000000000000E+00 beta (00000398)=0.133743611720961E+02 gamma(00000398)=0.133743611720961E+02 lr_calc_dens: Charge drift due to real space implementation = 0.91182E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 398 z1= 1 0.400776559243065E-04 0.000000000000000E+00 z1= 2 0.103266476603708E-01 0.000000000000000E+00 z1= 3 -.232906836793548E-05 0.000000000000000E+00 alpha(00000398)=0.000000000000000E+00 beta (00000399)=0.130856644053459E+02 gamma(00000399)=0.130856644053459E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10067E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 399 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000399)=0.000000000000000E+00 beta (00000400)=0.134967025139495E+02 gamma(00000400)=0.134967025139495E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12651E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 400 z1= 1 -.394776642051713E-04 0.000000000000000E+00 z1= 2 -.107777432167463E-01 0.000000000000000E+00 z1= 3 0.142419729686079E-05 0.000000000000000E+00 alpha(00000400)=0.000000000000000E+00 beta (00000401)=0.130038699082116E+02 gamma(00000401)=0.130038699082116E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10300E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 401 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000401)=0.000000000000000E+00 beta (00000402)=0.133513015892841E+02 gamma(00000402)=0.133513015892841E+02 lr_calc_dens: Charge drift due to real space implementation = 0.55611E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 402 z1= 1 0.402568081414307E-04 0.000000000000000E+00 z1= 2 0.114252347041448E-01 0.000000000000000E+00 z1= 3 -.735645454065732E-06 0.000000000000000E+00 alpha(00000402)=0.000000000000000E+00 beta (00000403)=0.131012064194213E+02 gamma(00000403)=0.131012064194213E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.15128E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 403 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000403)=0.000000000000000E+00 beta (00000404)=0.135325523401094E+02 gamma(00000404)=0.135325523401094E+02 lr_calc_dens: Charge drift due to real space implementation = 0.48963E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 404 z1= 1 -.403235963316257E-04 0.000000000000000E+00 z1= 2 -.120540434259457E-01 0.000000000000000E+00 z1= 3 0.574780184482080E-06 0.000000000000000E+00 alpha(00000404)=0.000000000000000E+00 beta (00000405)=0.130976317455601E+02 gamma(00000405)=0.130976317455601E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12172E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 405 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000405)=0.000000000000000E+00 beta (00000406)=0.134321107185012E+02 gamma(00000406)=0.134321107185012E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12902E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 406 z1= 1 0.409500670188094E-04 0.000000000000000E+00 z1= 2 0.127300696752899E-01 0.000000000000000E+00 z1= 3 -.267403537178094E-06 0.000000000000000E+00 alpha(00000406)=0.000000000000000E+00 beta (00000407)=0.130992761811476E+02 gamma(00000407)=0.130992761811476E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.20613E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 407 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000407)=0.000000000000000E+00 beta (00000408)=0.135851118901197E+02 gamma(00000408)=0.135851118901197E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10957E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 408 z1= 1 -.413918926078084E-04 0.000000000000000E+00 z1= 2 -.131465579194033E-01 0.000000000000000E+00 z1= 3 0.301315314613750E-06 0.000000000000000E+00 alpha(00000408)=0.000000000000000E+00 beta (00000409)=0.129731034799162E+02 gamma(00000409)=0.129731034799162E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.56171E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 409 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000409)=0.000000000000000E+00 beta (00000410)=0.135022333542783E+02 gamma(00000410)=0.135022333542783E+02 lr_calc_dens: Charge drift due to real space implementation = -0.32139E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 410 z1= 1 0.431724953675453E-04 0.000000000000000E+00 z1= 2 0.135059059624178E-01 0.000000000000000E+00 z1= 3 -.642678810291574E-06 0.000000000000000E+00 alpha(00000410)=0.000000000000000E+00 beta (00000411)=0.129212922567812E+02 gamma(00000411)=0.129212922567812E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.71489E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 411 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000411)=0.000000000000000E+00 beta (00000412)=0.135103853013333E+02 gamma(00000412)=0.135103853013333E+02 lr_calc_dens: Charge drift due to real space implementation = -0.46074E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 412 z1= 1 -.453551302027578E-04 0.000000000000000E+00 z1= 2 -.136654761695270E-01 0.000000000000000E+00 z1= 3 0.145638219956959E-05 0.000000000000000E+00 alpha(00000412)=0.000000000000000E+00 beta (00000413)=0.129980678862182E+02 gamma(00000413)=0.129980678862182E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.29452E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 413 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000413)=0.000000000000000E+00 beta (00000414)=0.135212128126958E+02 gamma(00000414)=0.135212128126958E+02 lr_calc_dens: Charge drift due to real space implementation = 0.78287E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 414 z1= 1 0.462323259632575E-04 0.000000000000000E+00 z1= 2 0.137636815491503E-01 0.000000000000000E+00 z1= 3 -.259952567977681E-05 0.000000000000000E+00 alpha(00000414)=0.000000000000000E+00 beta (00000415)=0.130262644160840E+02 gamma(00000415)=0.130262644160840E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.34754E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 415 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000415)=0.000000000000000E+00 beta (00000416)=0.134572429437484E+02 gamma(00000416)=0.134572429437484E+02 lr_calc_dens: Charge drift due to real space implementation = -0.47683E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 416 z1= 1 -.452534487943978E-04 0.000000000000000E+00 z1= 2 -.138615391636406E-01 0.000000000000000E+00 z1= 3 0.436026329433382E-05 0.000000000000000E+00 alpha(00000416)=0.000000000000000E+00 beta (00000417)=0.130551668738082E+02 gamma(00000417)=0.130551668738082E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.71656E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 417 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000417)=0.000000000000000E+00 beta (00000418)=0.134571497586213E+02 gamma(00000418)=0.134571497586213E+02 lr_calc_dens: Charge drift due to real space implementation = -0.42831E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 418 z1= 1 0.448929195615689E-04 0.000000000000000E+00 z1= 2 0.139614506817956E-01 0.000000000000000E+00 z1= 3 -.595554378515429E-05 0.000000000000000E+00 alpha(00000418)=0.000000000000000E+00 beta (00000419)=0.130972173510373E+02 gamma(00000419)=0.130972173510373E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.76255E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 419 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000419)=0.000000000000000E+00 beta (00000420)=0.136283486976245E+02 gamma(00000420)=0.136283486976245E+02 lr_calc_dens: Charge drift due to real space implementation = 0.54684E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 420 z1= 1 -.452804055757561E-04 0.000000000000000E+00 z1= 2 -.139569117355418E-01 0.000000000000000E+00 z1= 3 0.799239590048114E-05 0.000000000000000E+00 alpha(00000420)=0.000000000000000E+00 beta (00000421)=0.130578754169462E+02 gamma(00000421)=0.130578754169462E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.45460E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 421 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000421)=0.000000000000000E+00 beta (00000422)=0.134550049015802E+02 gamma(00000422)=0.134550049015802E+02 lr_calc_dens: Charge drift due to real space implementation = -0.71564E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 422 z1= 1 0.465554462107276E-04 0.000000000000000E+00 z1= 2 0.140767798871426E-01 0.000000000000000E+00 z1= 3 -.104138277554976E-04 0.000000000000000E+00 alpha(00000422)=0.000000000000000E+00 beta (00000423)=0.129328064927447E+02 gamma(00000423)=0.129328064927447E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10434E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 423 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000423)=0.000000000000000E+00 beta (00000424)=0.135159579535566E+02 gamma(00000424)=0.135159579535566E+02 lr_calc_dens: Charge drift due to real space implementation = 0.65566E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 424 z1= 1 -.467758182589322E-04 0.000000000000000E+00 z1= 2 -.139624130152741E-01 0.000000000000000E+00 z1= 3 0.130026375026602E-04 0.000000000000000E+00 alpha(00000424)=0.000000000000000E+00 beta (00000425)=0.129490275102848E+02 gamma(00000425)=0.129490275102848E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.34145E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 425 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000425)=0.000000000000000E+00 beta (00000426)=0.136236752292324E+02 gamma(00000426)=0.136236752292324E+02 lr_calc_dens: Charge drift due to real space implementation = -0.13922E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 426 z1= 1 0.470828807199674E-04 0.000000000000000E+00 z1= 2 0.137106439760962E-01 0.000000000000000E+00 z1= 3 -.155259538648261E-04 0.000000000000000E+00 alpha(00000426)=0.000000000000000E+00 beta (00000427)=0.130263573649067E+02 gamma(00000427)=0.130263573649067E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.26461E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 427 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000427)=0.000000000000000E+00 beta (00000428)=0.135250988908868E+02 gamma(00000428)=0.135250988908868E+02 lr_calc_dens: Charge drift due to real space implementation = -0.15850E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 428 z1= 1 -.472765489511430E-04 0.000000000000000E+00 z1= 2 -.136094721991959E-01 0.000000000000000E+00 z1= 3 0.184889102326487E-04 0.000000000000000E+00 alpha(00000428)=0.000000000000000E+00 beta (00000429)=0.130008614957513E+02 gamma(00000429)=0.130008614957513E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.57504E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 429 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000429)=0.000000000000000E+00 beta (00000430)=0.134601180490369E+02 gamma(00000430)=0.134601180490369E+02 lr_calc_dens: Charge drift due to real space implementation = 0.16155E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 430 z1= 1 0.485480122850088E-04 0.000000000000000E+00 z1= 2 0.134965430807768E-01 0.000000000000000E+00 z1= 3 -.206068345844310E-04 0.000000000000000E+00 alpha(00000430)=0.000000000000000E+00 beta (00000431)=0.131077985117629E+02 gamma(00000431)=0.131077985117629E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14415E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 431 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000431)=0.000000000000000E+00 beta (00000432)=0.134657910266977E+02 gamma(00000432)=0.134657910266977E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12356E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 432 z1= 1 -.500208889349688E-04 0.000000000000000E+00 z1= 2 -.134758617927560E-01 0.000000000000000E+00 z1= 3 0.228238317448802E-04 0.000000000000000E+00 alpha(00000432)=0.000000000000000E+00 beta (00000433)=0.129677950286491E+02 gamma(00000433)=0.129677950286491E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.47037E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 433 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000433)=0.000000000000000E+00 beta (00000434)=0.134894820445691E+02 gamma(00000434)=0.134894820445691E+02 lr_calc_dens: Charge drift due to real space implementation = -0.93812E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 434 z1= 1 0.509030618811978E-04 0.000000000000000E+00 z1= 2 0.132097461526661E-01 0.000000000000000E+00 z1= 3 -.246014578206402E-04 0.000000000000000E+00 alpha(00000434)=0.000000000000000E+00 beta (00000435)=0.129407066294588E+02 gamma(00000435)=0.129407066294588E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.30811E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 435 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000435)=0.000000000000000E+00 beta (00000436)=0.134760802943534E+02 gamma(00000436)=0.134760802943534E+02 lr_calc_dens: Charge drift due to real space implementation = -0.46571E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 436 z1= 1 -.533606419819621E-04 0.000000000000000E+00 z1= 2 -.128425711771408E-01 0.000000000000000E+00 z1= 3 0.267610108658100E-04 0.000000000000000E+00 alpha(00000436)=0.000000000000000E+00 beta (00000437)=0.130053822132075E+02 gamma(00000437)=0.130053822132075E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.14891E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 437 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000437)=0.000000000000000E+00 beta (00000438)=0.134910510457827E+02 gamma(00000438)=0.134910510457827E+02 lr_calc_dens: Charge drift due to real space implementation = 0.45034E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 438 z1= 1 0.555571054172916E-04 0.000000000000000E+00 z1= 2 0.125467910773306E-01 0.000000000000000E+00 z1= 3 -.288230298574148E-04 0.000000000000000E+00 alpha(00000438)=0.000000000000000E+00 beta (00000439)=0.129758363564545E+02 gamma(00000439)=0.129758363564545E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.70858E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 439 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000439)=0.000000000000000E+00 beta (00000440)=0.135492996678511E+02 gamma(00000440)=0.135492996678511E+02 lr_calc_dens: Charge drift due to real space implementation = 0.16411E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 440 z1= 1 -.547846571132471E-04 0.000000000000000E+00 z1= 2 -.122310703815758E-01 0.000000000000000E+00 z1= 3 0.311140225941476E-04 0.000000000000000E+00 alpha(00000440)=0.000000000000000E+00 beta (00000441)=0.130265184919458E+02 gamma(00000441)=0.130265184919458E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.60077E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 441 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000441)=0.000000000000000E+00 beta (00000442)=0.134171214385407E+02 gamma(00000442)=0.134171214385407E+02 lr_calc_dens: Charge drift due to real space implementation = -0.50018E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 442 z1= 1 0.551859449522234E-04 0.000000000000000E+00 z1= 2 0.121721935130358E-01 0.000000000000000E+00 z1= 3 -.332401245905936E-04 0.000000000000000E+00 alpha(00000442)=0.000000000000000E+00 beta (00000443)=0.130639689745166E+02 gamma(00000443)=0.130639689745166E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.18398E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 443 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000443)=0.000000000000000E+00 beta (00000444)=0.135014439227358E+02 gamma(00000444)=0.135014439227358E+02 lr_calc_dens: Charge drift due to real space implementation = 0.27944E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 444 z1= 1 -.576103366349166E-04 0.000000000000000E+00 z1= 2 -.121962054196177E-01 0.000000000000000E+00 z1= 3 0.352504434449892E-04 0.000000000000000E+00 alpha(00000444)=0.000000000000000E+00 beta (00000445)=0.129787298017312E+02 gamma(00000445)=0.129787298017312E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12760E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 445 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000445)=0.000000000000000E+00 beta (00000446)=0.135922378445313E+02 gamma(00000446)=0.135922378445313E+02 lr_calc_dens: Charge drift due to real space implementation = 0.57618E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 446 z1= 1 0.588474871285778E-04 0.000000000000000E+00 z1= 2 0.120693694662975E-01 0.000000000000000E+00 z1= 3 -.361842722584194E-04 0.000000000000000E+00 alpha(00000446)=0.000000000000000E+00 beta (00000447)=0.129523223254143E+02 gamma(00000447)=0.129523223254143E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.49387E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 447 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000447)=0.000000000000000E+00 beta (00000448)=0.135047900138521E+02 gamma(00000448)=0.135047900138521E+02 lr_calc_dens: Charge drift due to real space implementation = 0.18202E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 448 z1= 1 -.592409073806501E-04 0.000000000000000E+00 z1= 2 -.118602123510038E-01 0.000000000000000E+00 z1= 3 0.374489314580183E-04 0.000000000000000E+00 alpha(00000448)=0.000000000000000E+00 beta (00000449)=0.129929735647190E+02 gamma(00000449)=0.129929735647190E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.37804E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 449 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000449)=0.000000000000000E+00 beta (00000450)=0.135150590276813E+02 gamma(00000450)=0.135150590276813E+02 lr_calc_dens: Charge drift due to real space implementation = -0.30988E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 450 z1= 1 0.589963043923000E-04 0.000000000000000E+00 z1= 2 0.116001034782606E-01 0.000000000000000E+00 z1= 3 -.388134829574140E-04 0.000000000000000E+00 alpha(00000450)=0.000000000000000E+00 beta (00000451)=0.130288329920655E+02 gamma(00000451)=0.130288329920655E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13358E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 451 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000451)=0.000000000000000E+00 beta (00000452)=0.134723112897348E+02 gamma(00000452)=0.134723112897348E+02 lr_calc_dens: Charge drift due to real space implementation = 0.15519E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 452 z1= 1 -.593591204745966E-04 0.000000000000000E+00 z1= 2 -.113845838874414E-01 0.000000000000000E+00 z1= 3 0.398292062375483E-04 0.000000000000000E+00 alpha(00000452)=0.000000000000000E+00 beta (00000453)=0.129678189303093E+02 gamma(00000453)=0.129678189303093E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.18475E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 453 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000453)=0.000000000000000E+00 beta (00000454)=0.135357245448546E+02 gamma(00000454)=0.135357245448546E+02 lr_calc_dens: Charge drift due to real space implementation = -0.16077E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 454 z1= 1 0.597968832722322E-04 0.000000000000000E+00 z1= 2 0.110054577228289E-01 0.000000000000000E+00 z1= 3 -.394138732725328E-04 0.000000000000000E+00 alpha(00000454)=0.000000000000000E+00 beta (00000455)=0.130625178966810E+02 gamma(00000455)=0.130625178966810E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.18181E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 455 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000455)=0.000000000000000E+00 beta (00000456)=0.135110188654726E+02 gamma(00000456)=0.135110188654726E+02 lr_calc_dens: Charge drift due to real space implementation = 0.22967E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 456 z1= 1 -.604609568527498E-04 0.000000000000000E+00 z1= 2 -.106691336460883E-01 0.000000000000000E+00 z1= 3 0.383978550528677E-04 0.000000000000000E+00 alpha(00000456)=0.000000000000000E+00 beta (00000457)=0.129833611071543E+02 gamma(00000457)=0.129833611071543E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.79101E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 457 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000457)=0.000000000000000E+00 beta (00000458)=0.134826255000606E+02 gamma(00000458)=0.134826255000606E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12736E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 458 z1= 1 0.599043342676357E-04 0.000000000000000E+00 z1= 2 0.102709601901727E-01 0.000000000000000E+00 z1= 3 -.365348102961994E-04 0.000000000000000E+00 alpha(00000458)=0.000000000000000E+00 beta (00000459)=0.130052011609205E+02 gamma(00000459)=0.130052011609205E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.24890E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 459 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000459)=0.000000000000000E+00 beta (00000460)=0.135266659842836E+02 gamma(00000460)=0.135266659842836E+02 lr_calc_dens: Charge drift due to real space implementation = 0.19871E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 460 z1= 1 -.609104495054320E-04 0.000000000000000E+00 z1= 2 -.997751410305469E-02 0.000000000000000E+00 z1= 3 0.342380692800368E-04 0.000000000000000E+00 alpha(00000460)=0.000000000000000E+00 beta (00000461)=0.129467288210018E+02 gamma(00000461)=0.129467288210018E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.51241E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 461 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000461)=0.000000000000000E+00 beta (00000462)=0.135666701189180E+02 gamma(00000462)=0.135666701189180E+02 lr_calc_dens: Charge drift due to real space implementation = -0.71459E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 462 z1= 1 0.592960584844537E-04 0.000000000000000E+00 z1= 2 0.980215675396454E-02 0.000000000000000E+00 z1= 3 -.315364838811207E-04 0.000000000000000E+00 alpha(00000462)=0.000000000000000E+00 beta (00000463)=0.131705566164753E+02 gamma(00000463)=0.131705566164753E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.26043E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 463 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000463)=0.000000000000000E+00 beta (00000464)=0.134921891103382E+02 gamma(00000464)=0.134921891103382E+02 lr_calc_dens: Charge drift due to real space implementation = 0.49025E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 464 z1= 1 -.606499944000626E-04 0.000000000000000E+00 z1= 2 -.100298151345589E-01 0.000000000000000E+00 z1= 3 0.301574096670957E-04 0.000000000000000E+00 alpha(00000464)=0.000000000000000E+00 beta (00000465)=0.129901754539303E+02 gamma(00000465)=0.129901754539303E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.30739E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 465 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000465)=0.000000000000000E+00 beta (00000466)=0.134766718750431E+02 gamma(00000466)=0.134766718750431E+02 lr_calc_dens: Charge drift due to real space implementation = -0.51194E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 466 z1= 1 0.597495589966550E-04 0.000000000000000E+00 z1= 2 0.102653863193301E-01 0.000000000000000E+00 z1= 3 -.287713657500408E-04 0.000000000000000E+00 alpha(00000466)=0.000000000000000E+00 beta (00000467)=0.130110156797247E+02 gamma(00000467)=0.130110156797247E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.17681E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 467 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000467)=0.000000000000000E+00 beta (00000468)=0.135034994271320E+02 gamma(00000468)=0.135034994271320E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11696E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 468 z1= 1 -.605927989924190E-04 0.000000000000000E+00 z1= 2 -.104653178551592E-01 0.000000000000000E+00 z1= 3 0.273997098166007E-04 0.000000000000000E+00 alpha(00000468)=0.000000000000000E+00 beta (00000469)=0.129621779938276E+02 gamma(00000469)=0.129621779938276E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.18239E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 469 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000469)=0.000000000000000E+00 beta (00000470)=0.134638401786428E+02 gamma(00000470)=0.134638401786428E+02 lr_calc_dens: Charge drift due to real space implementation = 0.17054E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 470 z1= 1 0.617407772711496E-04 0.000000000000000E+00 z1= 2 0.105123114101619E-01 0.000000000000000E+00 z1= 3 -.260700227471501E-04 0.000000000000000E+00 alpha(00000470)=0.000000000000000E+00 beta (00000471)=0.130377963772198E+02 gamma(00000471)=0.130377963772198E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.23367E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 471 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000471)=0.000000000000000E+00 beta (00000472)=0.135605283577455E+02 gamma(00000472)=0.135605283577455E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12478E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 472 z1= 1 -.621443868197898E-04 0.000000000000000E+00 z1= 2 -.104319632960485E-01 0.000000000000000E+00 z1= 3 0.253669897532272E-04 0.000000000000000E+00 alpha(00000472)=0.000000000000000E+00 beta (00000473)=0.130648603798935E+02 gamma(00000473)=0.130648603798935E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11014E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 473 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000473)=0.000000000000000E+00 beta (00000474)=0.135041960834484E+02 gamma(00000474)=0.135041960834484E+02 lr_calc_dens: Charge drift due to real space implementation = -0.34568E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 474 z1= 1 0.614975018822066E-04 0.000000000000000E+00 z1= 2 0.104121281302855E-01 0.000000000000000E+00 z1= 3 -.248463903256591E-04 0.000000000000000E+00 alpha(00000474)=0.000000000000000E+00 beta (00000475)=0.130881438743068E+02 gamma(00000475)=0.130881438743068E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.38861E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 475 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000475)=0.000000000000000E+00 beta (00000476)=0.133847208044372E+02 gamma(00000476)=0.133847208044372E+02 lr_calc_dens: Charge drift due to real space implementation = -0.19710E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 476 z1= 1 -.620655841055348E-04 0.000000000000000E+00 z1= 2 -.105165060560998E-01 0.000000000000000E+00 z1= 3 0.246063927022326E-04 0.000000000000000E+00 alpha(00000476)=0.000000000000000E+00 beta (00000477)=0.131654820211411E+02 gamma(00000477)=0.131654820211411E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.35897E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 477 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000477)=0.000000000000000E+00 beta (00000478)=0.135768040339925E+02 gamma(00000478)=0.135768040339925E+02 lr_calc_dens: Charge drift due to real space implementation = 0.27785E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 478 z1= 1 0.607091951298887E-04 0.000000000000000E+00 z1= 2 0.106288258742655E-01 0.000000000000000E+00 z1= 3 -.236669524065312E-04 0.000000000000000E+00 alpha(00000478)=0.000000000000000E+00 beta (00000479)=0.130031930740048E+02 gamma(00000479)=0.130031930740048E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.55005E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 479 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000479)=0.000000000000000E+00 beta (00000480)=0.134771605755490E+02 gamma(00000480)=0.134771605755490E+02 lr_calc_dens: Charge drift due to real space implementation = 0.33275E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 480 z1= 1 -.584329388441142E-04 0.000000000000000E+00 z1= 2 -.108559174333890E-01 0.000000000000000E+00 z1= 3 0.229976376691685E-04 0.000000000000000E+00 alpha(00000480)=0.000000000000000E+00 beta (00000481)=0.129872545962690E+02 gamma(00000481)=0.129872545962690E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.42229E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 481 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000481)=0.000000000000000E+00 beta (00000482)=0.134422096093463E+02 gamma(00000482)=0.134422096093463E+02 lr_calc_dens: Charge drift due to real space implementation = -0.56412E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 482 z1= 1 0.558328769684306E-04 0.000000000000000E+00 z1= 2 0.111766728415607E-01 0.000000000000000E+00 z1= 3 -.227042293989095E-04 0.000000000000000E+00 alpha(00000482)=0.000000000000000E+00 beta (00000483)=0.131005293361908E+02 gamma(00000483)=0.131005293361908E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.25240E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 483 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000483)=0.000000000000000E+00 beta (00000484)=0.134726430688066E+02 gamma(00000484)=0.134726430688066E+02 lr_calc_dens: Charge drift due to real space implementation = 0.96302E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 484 z1= 1 -.550815891567306E-04 0.000000000000000E+00 z1= 2 -.115338090419867E-01 0.000000000000000E+00 z1= 3 0.229667970882410E-04 0.000000000000000E+00 alpha(00000484)=0.000000000000000E+00 beta (00000485)=0.130188206883796E+02 gamma(00000485)=0.130188206883796E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.83343E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 485 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000485)=0.000000000000000E+00 beta (00000486)=0.135769381685035E+02 gamma(00000486)=0.135769381685035E+02 lr_calc_dens: Charge drift due to real space implementation = 0.91482E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 486 z1= 1 0.541835375055264E-04 0.000000000000000E+00 z1= 2 0.115206455852960E-01 0.000000000000000E+00 z1= 3 -.228798165529178E-04 0.000000000000000E+00 alpha(00000486)=0.000000000000000E+00 beta (00000487)=0.129717684358793E+02 gamma(00000487)=0.129717684358793E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.69232E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 487 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000487)=0.000000000000000E+00 beta (00000488)=0.134471854583865E+02 gamma(00000488)=0.134471854583865E+02 lr_calc_dens: Charge drift due to real space implementation = -0.99168E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 488 z1= 1 -.530824163431885E-04 0.000000000000000E+00 z1= 2 -.113645600546357E-01 0.000000000000000E+00 z1= 3 0.227484568830787E-04 0.000000000000000E+00 alpha(00000488)=0.000000000000000E+00 beta (00000489)=0.130710149839000E+02 gamma(00000489)=0.130710149839000E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.56714E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 489 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000489)=0.000000000000000E+00 beta (00000490)=0.134023231792172E+02 gamma(00000490)=0.134023231792172E+02 lr_calc_dens: Charge drift due to real space implementation = 0.29466E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 490 z1= 1 0.517879570679884E-04 0.000000000000000E+00 z1= 2 0.111824432995521E-01 0.000000000000000E+00 z1= 3 -.233093022110171E-04 0.000000000000000E+00 alpha(00000490)=0.000000000000000E+00 beta (00000491)=0.130571071825418E+02 gamma(00000491)=0.130571071825418E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.75643E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 491 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000491)=0.000000000000000E+00 beta (00000492)=0.134645585146193E+02 gamma(00000492)=0.134645585146193E+02 lr_calc_dens: Charge drift due to real space implementation = 0.23726E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 492 z1= 1 -.517489865639251E-04 0.000000000000000E+00 z1= 2 -.108479726617100E-01 0.000000000000000E+00 z1= 3 0.241018021675392E-04 0.000000000000000E+00 alpha(00000492)=0.000000000000000E+00 beta (00000493)=0.131227150102137E+02 gamma(00000493)=0.131227150102137E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.50583E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 493 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000493)=0.000000000000000E+00 beta (00000494)=0.135537441959452E+02 gamma(00000494)=0.135537441959452E+02 lr_calc_dens: Charge drift due to real space implementation = -0.55708E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 494 z1= 1 0.510237003683803E-04 0.000000000000000E+00 z1= 2 0.105889163251344E-01 0.000000000000000E+00 z1= 3 -.249082515384046E-04 0.000000000000000E+00 alpha(00000494)=0.000000000000000E+00 beta (00000495)=0.130023113187139E+02 gamma(00000495)=0.130023113187139E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.14192E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 495 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000495)=0.000000000000000E+00 beta (00000496)=0.134734787425228E+02 gamma(00000496)=0.134734787425228E+02 lr_calc_dens: Charge drift due to real space implementation = 0.31560E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 496 z1= 1 -.491357495548831E-04 0.000000000000000E+00 z1= 2 -.104740255192311E-01 0.000000000000000E+00 z1= 3 0.259952008101774E-04 0.000000000000000E+00 alpha(00000496)=0.000000000000000E+00 beta (00000497)=0.130374699812824E+02 gamma(00000497)=0.130374699812824E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.60177E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 497 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000497)=0.000000000000000E+00 beta (00000498)=0.135100555816068E+02 gamma(00000498)=0.135100555816068E+02 lr_calc_dens: Charge drift due to real space implementation = 0.52603E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 498 z1= 1 0.470257323630738E-04 0.000000000000000E+00 z1= 2 0.104797419224277E-01 0.000000000000000E+00 z1= 3 -.270213754326229E-04 0.000000000000000E+00 alpha(00000498)=0.000000000000000E+00 beta (00000499)=0.129856162080488E+02 gamma(00000499)=0.129856162080488E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.44665E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 499 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000499)=0.000000000000000E+00 beta (00000500)=0.135141931138977E+02 gamma(00000500)=0.135141931138977E+02 lr_calc_dens: Charge drift due to real space implementation = -0.49574E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 500 z1= 1 -.439122141343428E-04 0.000000000000000E+00 z1= 2 -.104291737596162E-01 0.000000000000000E+00 z1= 3 0.285816217802773E-04 0.000000000000000E+00 alpha(00000500)=0.000000000000000E+00 beta (00000501)=0.129912238728319E+02 gamma(00000501)=0.129912238728319E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.71679E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 501 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000501)=0.000000000000000E+00 beta (00000502)=0.135277597698552E+02 gamma(00000502)=0.135277597698552E+02 lr_calc_dens: Charge drift due to real space implementation = -0.37794E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 502 z1= 1 0.410431678546207E-04 0.000000000000000E+00 z1= 2 0.102883823271535E-01 0.000000000000000E+00 z1= 3 -.302046707308291E-04 0.000000000000000E+00 alpha(00000502)=0.000000000000000E+00 beta (00000503)=0.130179230866053E+02 gamma(00000503)=0.130179230866053E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.32024E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 503 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000503)=0.000000000000000E+00 beta (00000504)=0.135014606839838E+02 gamma(00000504)=0.135014606839838E+02 lr_calc_dens: Charge drift due to real space implementation = 0.38812E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 504 z1= 1 -.378819917259692E-04 0.000000000000000E+00 z1= 2 -.100307564965232E-01 0.000000000000000E+00 z1= 3 0.322687242334547E-04 0.000000000000000E+00 alpha(00000504)=0.000000000000000E+00 beta (00000505)=0.129731808159824E+02 gamma(00000505)=0.129731808159824E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.99116E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 505 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000505)=0.000000000000000E+00 beta (00000506)=0.135458919297772E+02 gamma(00000506)=0.135458919297772E+02 lr_calc_dens: Charge drift due to real space implementation = 0.15245E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 506 z1= 1 0.347860639550502E-04 0.000000000000000E+00 z1= 2 0.954050005406441E-02 0.000000000000000E+00 z1= 3 -.338981347013106E-04 0.000000000000000E+00 alpha(00000506)=0.000000000000000E+00 beta (00000507)=0.130205437783010E+02 gamma(00000507)=0.130205437783010E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.78671E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 507 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000507)=0.000000000000000E+00 beta (00000508)=0.135048782313005E+02 gamma(00000508)=0.135048782313005E+02 lr_calc_dens: Charge drift due to real space implementation = 0.16703E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 508 z1= 1 -.358623918938756E-04 0.000000000000000E+00 z1= 2 -.907321171007891E-02 0.000000000000000E+00 z1= 3 0.360834758007315E-04 0.000000000000000E+00 alpha(00000508)=0.000000000000000E+00 beta (00000509)=0.129631760006445E+02 gamma(00000509)=0.129631760006445E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.94039E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 509 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000509)=0.000000000000000E+00 beta (00000510)=0.134876999664933E+02 gamma(00000510)=0.134876999664933E+02 lr_calc_dens: Charge drift due to real space implementation = -0.62316E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 510 z1= 1 0.365246005671446E-04 0.000000000000000E+00 z1= 2 0.854586126094917E-02 0.000000000000000E+00 z1= 3 -.382790751304634E-04 0.000000000000000E+00 alpha(00000510)=0.000000000000000E+00 beta (00000511)=0.129237974629889E+02 gamma(00000511)=0.129237974629889E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.32560E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 511 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000511)=0.000000000000000E+00 beta (00000512)=0.135588138168486E+02 gamma(00000512)=0.135588138168486E+02 lr_calc_dens: Charge drift due to real space implementation = 0.46185E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 512 z1= 1 -.352664426063140E-04 0.000000000000000E+00 z1= 2 -.790304623092770E-02 0.000000000000000E+00 z1= 3 0.404850220801108E-04 0.000000000000000E+00 alpha(00000512)=0.000000000000000E+00 beta (00000513)=0.130150694703757E+02 gamma(00000513)=0.130150694703757E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.23321E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 513 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000513)=0.000000000000000E+00 beta (00000514)=0.134824230530463E+02 gamma(00000514)=0.134824230530463E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10600E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 514 z1= 1 0.344631566177043E-04 0.000000000000000E+00 z1= 2 0.749802817087423E-02 0.000000000000000E+00 z1= 3 -.425341126809547E-04 0.000000000000000E+00 alpha(00000514)=0.000000000000000E+00 beta (00000515)=0.130299320665363E+02 gamma(00000515)=0.130299320665363E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.29124E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 515 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000515)=0.000000000000000E+00 beta (00000516)=0.135197539727566E+02 gamma(00000516)=0.135197539727566E+02 lr_calc_dens: Charge drift due to real space implementation = -0.64723E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 516 z1= 1 -.319902492965634E-04 0.000000000000000E+00 z1= 2 -.718766240555475E-02 0.000000000000000E+00 z1= 3 0.440423361267737E-04 0.000000000000000E+00 alpha(00000516)=0.000000000000000E+00 beta (00000517)=0.129719755232833E+02 gamma(00000517)=0.129719755232833E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.30992E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 517 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000517)=0.000000000000000E+00 beta (00000518)=0.135446220578315E+02 gamma(00000518)=0.135446220578315E+02 lr_calc_dens: Charge drift due to real space implementation = 0.51631E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 518 z1= 1 0.301053397667216E-04 0.000000000000000E+00 z1= 2 0.683128267247349E-02 0.000000000000000E+00 z1= 3 -.447139109950941E-04 0.000000000000000E+00 alpha(00000518)=0.000000000000000E+00 beta (00000519)=0.129828359422903E+02 gamma(00000519)=0.129828359422903E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.88943E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 519 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000519)=0.000000000000000E+00 beta (00000520)=0.134560228541313E+02 gamma(00000520)=0.134560228541313E+02 lr_calc_dens: Charge drift due to real space implementation = 0.56612E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 520 z1= 1 -.281571902094363E-04 0.000000000000000E+00 z1= 2 -.656802413205750E-02 0.000000000000000E+00 z1= 3 0.452556256433576E-04 0.000000000000000E+00 alpha(00000520)=0.000000000000000E+00 beta (00000521)=0.129215236187854E+02 gamma(00000521)=0.129215236187854E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10158E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 521 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000521)=0.000000000000000E+00 beta (00000522)=0.135880261914917E+02 gamma(00000522)=0.135880261914917E+02 lr_calc_dens: Charge drift due to real space implementation = -0.48200E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 522 z1= 1 0.271129375765203E-04 0.000000000000000E+00 z1= 2 0.625262544868308E-02 0.000000000000000E+00 z1= 3 -.448009251333805E-04 0.000000000000000E+00 alpha(00000522)=0.000000000000000E+00 beta (00000523)=0.129589987986373E+02 gamma(00000523)=0.129589987986373E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.93413E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 523 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000523)=0.000000000000000E+00 beta (00000524)=0.135188990367584E+02 gamma(00000524)=0.135188990367584E+02 lr_calc_dens: Charge drift due to real space implementation = 0.75092E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 524 z1= 1 -.275537703840563E-04 0.000000000000000E+00 z1= 2 -.603330506933099E-02 0.000000000000000E+00 z1= 3 0.445515445013585E-04 0.000000000000000E+00 alpha(00000524)=0.000000000000000E+00 beta (00000525)=0.129762048469350E+02 gamma(00000525)=0.129762048469350E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.71341E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 525 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000525)=0.000000000000000E+00 beta (00000526)=0.135453363627653E+02 gamma(00000526)=0.135453363627653E+02 lr_calc_dens: Charge drift due to real space implementation = -0.94034E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 526 z1= 1 0.273228978163080E-04 0.000000000000000E+00 z1= 2 0.586413034739092E-02 0.000000000000000E+00 z1= 3 -.445983616635892E-04 0.000000000000000E+00 alpha(00000526)=0.000000000000000E+00 beta (00000527)=0.129630689481043E+02 gamma(00000527)=0.129630689481043E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.34933E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 527 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000527)=0.000000000000000E+00 beta (00000528)=0.135641077213885E+02 gamma(00000528)=0.135641077213885E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10854E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 528 z1= 1 -.264113130415819E-04 0.000000000000000E+00 z1= 2 -.564423129474543E-02 0.000000000000000E+00 z1= 3 0.445641334942496E-04 0.000000000000000E+00 alpha(00000528)=0.000000000000000E+00 beta (00000529)=0.130355251108595E+02 gamma(00000529)=0.130355251108595E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.45272E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 529 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000529)=0.000000000000000E+00 beta (00000530)=0.135622671915923E+02 gamma(00000530)=0.135622671915923E+02 lr_calc_dens: Charge drift due to real space implementation = -0.50638E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 530 z1= 1 0.259443252650995E-04 0.000000000000000E+00 z1= 2 0.534203852961970E-02 0.000000000000000E+00 z1= 3 -.440093095942882E-04 0.000000000000000E+00 alpha(00000530)=0.000000000000000E+00 beta (00000531)=0.131096750565902E+02 gamma(00000531)=0.131096750565902E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.80849E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 531 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000531)=0.000000000000000E+00 beta (00000532)=0.134253565309329E+02 gamma(00000532)=0.134253565309329E+02 lr_calc_dens: Charge drift due to real space implementation = -0.36744E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 532 z1= 1 -.250486893460088E-04 0.000000000000000E+00 z1= 2 -.501124865181058E-02 0.000000000000000E+00 z1= 3 0.436068879951152E-04 0.000000000000000E+00 alpha(00000532)=0.000000000000000E+00 beta (00000533)=0.130658665486656E+02 gamma(00000533)=0.130658665486656E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.19075E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 533 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000533)=0.000000000000000E+00 beta (00000534)=0.134581158145879E+02 gamma(00000534)=0.134581158145879E+02 lr_calc_dens: Charge drift due to real space implementation = 0.36602E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 534 z1= 1 0.237969836567352E-04 0.000000000000000E+00 z1= 2 0.457198962373281E-02 0.000000000000000E+00 z1= 3 -.431715236936501E-04 0.000000000000000E+00 alpha(00000534)=0.000000000000000E+00 beta (00000535)=0.130141111933646E+02 gamma(00000535)=0.130141111933646E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.20164E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 535 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000535)=0.000000000000000E+00 beta (00000536)=0.136766115692416E+02 gamma(00000536)=0.136766115692416E+02 lr_calc_dens: Charge drift due to real space implementation = -0.90683E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 536 z1= 1 -.225949676477995E-04 0.000000000000000E+00 z1= 2 -.409506420965426E-02 0.000000000000000E+00 z1= 3 0.423487982414032E-04 0.000000000000000E+00 alpha(00000536)=0.000000000000000E+00 beta (00000537)=0.129989764603379E+02 gamma(00000537)=0.129989764603379E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.17146E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 537 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000537)=0.000000000000000E+00 beta (00000538)=0.135428664616457E+02 gamma(00000538)=0.135428664616457E+02 lr_calc_dens: Charge drift due to real space implementation = 0.64477E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 538 z1= 1 0.204204680728883E-04 0.000000000000000E+00 z1= 2 0.377545213134623E-02 0.000000000000000E+00 z1= 3 -.420385679519247E-04 0.000000000000000E+00 alpha(00000538)=0.000000000000000E+00 beta (00000539)=0.130093001770475E+02 gamma(00000539)=0.130093001770475E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.85663E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 539 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000539)=0.000000000000000E+00 beta (00000540)=0.135400922200546E+02 gamma(00000540)=0.135400922200546E+02 lr_calc_dens: Charge drift due to real space implementation = -0.46490E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 540 z1= 1 -.205769473224330E-04 0.000000000000000E+00 z1= 2 -.358284110571094E-02 0.000000000000000E+00 z1= 3 0.418800332848875E-04 0.000000000000000E+00 alpha(00000540)=0.000000000000000E+00 beta (00000541)=0.130185512198217E+02 gamma(00000541)=0.130185512198217E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.89214E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 541 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000541)=0.000000000000000E+00 beta (00000542)=0.135859922174338E+02 gamma(00000542)=0.135859922174338E+02 lr_calc_dens: Charge drift due to real space implementation = -0.27915E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 542 z1= 1 0.204499989722782E-04 0.000000000000000E+00 z1= 2 0.344319754376709E-02 0.000000000000000E+00 z1= 3 -.409155655418486E-04 0.000000000000000E+00 alpha(00000542)=0.000000000000000E+00 beta (00000543)=0.128861499006893E+02 gamma(00000543)=0.128861499006893E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.79980E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 543 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000543)=0.000000000000000E+00 beta (00000544)=0.135604849230169E+02 gamma(00000544)=0.135604849230169E+02 lr_calc_dens: Charge drift due to real space implementation = 0.95224E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 544 z1= 1 -.193310577960416E-04 0.000000000000000E+00 z1= 2 -.316800388790649E-02 0.000000000000000E+00 z1= 3 0.396095310328764E-04 0.000000000000000E+00 alpha(00000544)=0.000000000000000E+00 beta (00000545)=0.129803574531033E+02 gamma(00000545)=0.129803574531033E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12429E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 545 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000545)=0.000000000000000E+00 beta (00000546)=0.134737183574780E+02 gamma(00000546)=0.134737183574780E+02 lr_calc_dens: Charge drift due to real space implementation = -0.40880E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 546 z1= 1 0.188911414320059E-04 0.000000000000000E+00 z1= 2 0.278737296780009E-02 0.000000000000000E+00 z1= 3 -.386439216284370E-04 0.000000000000000E+00 alpha(00000546)=0.000000000000000E+00 beta (00000547)=0.129749228144106E+02 gamma(00000547)=0.129749228144106E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10859E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 547 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000547)=0.000000000000000E+00 beta (00000548)=0.134609670179279E+02 gamma(00000548)=0.134609670179279E+02 lr_calc_dens: Charge drift due to real space implementation = 0.47818E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 548 z1= 1 -.220821987134421E-04 0.000000000000000E+00 z1= 2 -.224557292212268E-02 0.000000000000000E+00 z1= 3 0.383279951568934E-04 0.000000000000000E+00 alpha(00000548)=0.000000000000000E+00 beta (00000549)=0.129350303890867E+02 gamma(00000549)=0.129350303890867E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.25048E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 549 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000549)=0.000000000000000E+00 beta (00000550)=0.135222807032845E+02 gamma(00000550)=0.135222807032845E+02 lr_calc_dens: Charge drift due to real space implementation = -0.31918E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 550 z1= 1 0.259530451090194E-04 0.000000000000000E+00 z1= 2 0.157943431998256E-02 0.000000000000000E+00 z1= 3 -.380790697081845E-04 0.000000000000000E+00 alpha(00000550)=0.000000000000000E+00 beta (00000551)=0.130423004933255E+02 gamma(00000551)=0.130423004933255E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.60026E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 551 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000551)=0.000000000000000E+00 beta (00000552)=0.135286473144153E+02 gamma(00000552)=0.135286473144153E+02 lr_calc_dens: Charge drift due to real space implementation = -0.29791E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 552 z1= 1 -.276321849472681E-04 0.000000000000000E+00 z1= 2 -.986321471879549E-03 0.000000000000000E+00 z1= 3 0.386098499291018E-04 0.000000000000000E+00 alpha(00000552)=0.000000000000000E+00 beta (00000553)=0.129817128386438E+02 gamma(00000553)=0.129817128386438E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.44515E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 553 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000553)=0.000000000000000E+00 beta (00000554)=0.135355693687500E+02 gamma(00000554)=0.135355693687500E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10302E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 554 z1= 1 0.287803233106235E-04 0.000000000000000E+00 z1= 2 0.598193310757814E-03 0.000000000000000E+00 z1= 3 -.379968960354280E-04 0.000000000000000E+00 alpha(00000554)=0.000000000000000E+00 beta (00000555)=0.129984615201415E+02 gamma(00000555)=0.129984615201415E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.68103E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 555 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000555)=0.000000000000000E+00 beta (00000556)=0.135455329523117E+02 gamma(00000556)=0.135455329523117E+02 lr_calc_dens: Charge drift due to real space implementation = -0.55292E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 556 z1= 1 -.307801519371220E-04 0.000000000000000E+00 z1= 2 -.470240486245309E-03 0.000000000000000E+00 z1= 3 0.383072515637237E-04 0.000000000000000E+00 alpha(00000556)=0.000000000000000E+00 beta (00000557)=0.129794232304116E+02 gamma(00000557)=0.129794232304116E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.13709E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 557 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000557)=0.000000000000000E+00 beta (00000558)=0.133951898983559E+02 gamma(00000558)=0.133951898983559E+02 lr_calc_dens: Charge drift due to real space implementation = -0.59733E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 558 z1= 1 0.313222302628867E-04 0.000000000000000E+00 z1= 2 0.556021271751658E-03 0.000000000000000E+00 z1= 3 -.389366747010463E-04 0.000000000000000E+00 alpha(00000558)=0.000000000000000E+00 beta (00000559)=0.130070068729220E+02 gamma(00000559)=0.130070068729220E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.84852E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 559 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000559)=0.000000000000000E+00 beta (00000560)=0.135389775347010E+02 gamma(00000560)=0.135389775347010E+02 lr_calc_dens: Charge drift due to real space implementation = 0.92069E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 560 z1= 1 -.297661922060797E-04 0.000000000000000E+00 z1= 2 -.752582805196651E-03 0.000000000000000E+00 z1= 3 0.390295827836173E-04 0.000000000000000E+00 alpha(00000560)=0.000000000000000E+00 beta (00000561)=0.129993178226385E+02 gamma(00000561)=0.129993178226385E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.33839E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 561 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000561)=0.000000000000000E+00 beta (00000562)=0.135058150499336E+02 gamma(00000562)=0.135058150499336E+02 lr_calc_dens: Charge drift due to real space implementation = -0.95254E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 562 z1= 1 0.287660364087635E-04 0.000000000000000E+00 z1= 2 0.881598865504539E-03 0.000000000000000E+00 z1= 3 -.395971685385619E-04 0.000000000000000E+00 alpha(00000562)=0.000000000000000E+00 beta (00000563)=0.130491874123921E+02 gamma(00000563)=0.130491874123921E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.34827E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 563 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000563)=0.000000000000000E+00 beta (00000564)=0.135673954929335E+02 gamma(00000564)=0.135673954929335E+02 lr_calc_dens: Charge drift due to real space implementation = 0.36181E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 564 z1= 1 -.288810536862127E-04 0.000000000000000E+00 z1= 2 -.887102050837861E-03 0.000000000000000E+00 z1= 3 0.395795069999338E-04 0.000000000000000E+00 alpha(00000564)=0.000000000000000E+00 beta (00000565)=0.130168832009862E+02 gamma(00000565)=0.130168832009862E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.48510E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 565 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000565)=0.000000000000000E+00 beta (00000566)=0.135641086183512E+02 gamma(00000566)=0.135641086183512E+02 lr_calc_dens: Charge drift due to real space implementation = 0.27545E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 566 z1= 1 0.309260242581078E-04 0.000000000000000E+00 z1= 2 0.784424116530068E-03 0.000000000000000E+00 z1= 3 -.391384026495178E-04 0.000000000000000E+00 alpha(00000566)=0.000000000000000E+00 beta (00000567)=0.129892991547757E+02 gamma(00000567)=0.129892991547757E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.17477E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 567 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000567)=0.000000000000000E+00 beta (00000568)=0.135137080862038E+02 gamma(00000568)=0.135137080862038E+02 lr_calc_dens: Charge drift due to real space implementation = -0.27340E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 568 z1= 1 -.344736833472639E-04 0.000000000000000E+00 z1= 2 -.686390027955416E-03 0.000000000000000E+00 z1= 3 0.392082013219795E-04 0.000000000000000E+00 alpha(00000568)=0.000000000000000E+00 beta (00000569)=0.129455323432745E+02 gamma(00000569)=0.129455323432745E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.39745E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 569 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000569)=0.000000000000000E+00 beta (00000570)=0.135991748339565E+02 gamma(00000570)=0.135991748339565E+02 lr_calc_dens: Charge drift due to real space implementation = -0.17033E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 570 z1= 1 0.349538235563988E-04 0.000000000000000E+00 z1= 2 0.724306810416866E-03 0.000000000000000E+00 z1= 3 -.383449955222727E-04 0.000000000000000E+00 alpha(00000570)=0.000000000000000E+00 beta (00000571)=0.129185769075481E+02 gamma(00000571)=0.129185769075481E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.80202E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 571 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000571)=0.000000000000000E+00 beta (00000572)=0.135926099914986E+02 gamma(00000572)=0.135926099914986E+02 lr_calc_dens: Charge drift due to real space implementation = 0.33867E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 572 z1= 1 -.368045171993980E-04 0.000000000000000E+00 z1= 2 -.856376877194128E-03 0.000000000000000E+00 z1= 3 0.370850650993808E-04 0.000000000000000E+00 alpha(00000572)=0.000000000000000E+00 beta (00000573)=0.130077966062666E+02 gamma(00000573)=0.130077966062666E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.75267E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 573 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000573)=0.000000000000000E+00 beta (00000574)=0.135977429969388E+02 gamma(00000574)=0.135977429969388E+02 lr_calc_dens: Charge drift due to real space implementation = 0.41293E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 574 z1= 1 0.381614302850677E-04 0.000000000000000E+00 z1= 2 0.113284761178685E-02 0.000000000000000E+00 z1= 3 -.358101091216292E-04 0.000000000000000E+00 alpha(00000574)=0.000000000000000E+00 beta (00000575)=0.130124740637719E+02 gamma(00000575)=0.130124740637719E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.48439E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 575 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000575)=0.000000000000000E+00 beta (00000576)=0.134844599933754E+02 gamma(00000576)=0.134844599933754E+02 lr_calc_dens: Charge drift due to real space implementation = -0.16303E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 576 z1= 1 -.402839662983715E-04 0.000000000000000E+00 z1= 2 -.159294113313828E-02 0.000000000000000E+00 z1= 3 0.353707773493450E-04 0.000000000000000E+00 alpha(00000576)=0.000000000000000E+00 beta (00000577)=0.129836725488143E+02 gamma(00000577)=0.129836725488143E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.98793E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 577 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000577)=0.000000000000000E+00 beta (00000578)=0.135531226917945E+02 gamma(00000578)=0.135531226917945E+02 lr_calc_dens: Charge drift due to real space implementation = -0.75408E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 578 z1= 1 0.429193595945171E-04 0.000000000000000E+00 z1= 2 0.216603328555587E-02 0.000000000000000E+00 z1= 3 -.346368990074901E-04 0.000000000000000E+00 alpha(00000578)=0.000000000000000E+00 beta (00000579)=0.130039783355919E+02 gamma(00000579)=0.130039783355919E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.53546E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 579 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000579)=0.000000000000000E+00 beta (00000580)=0.135081256535383E+02 gamma(00000580)=0.135081256535383E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11058E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 580 z1= 1 -.451604788574266E-04 0.000000000000000E+00 z1= 2 -.275930168288768E-02 0.000000000000000E+00 z1= 3 0.350317069128266E-04 0.000000000000000E+00 alpha(00000580)=0.000000000000000E+00 beta (00000581)=0.130046410075292E+02 gamma(00000581)=0.130046410075292E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.39133E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 581 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000581)=0.000000000000000E+00 beta (00000582)=0.134993524377729E+02 gamma(00000582)=0.134993524377729E+02 lr_calc_dens: Charge drift due to real space implementation = -0.42511E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 582 z1= 1 0.440364997365914E-04 0.000000000000000E+00 z1= 2 0.320789968221135E-02 0.000000000000000E+00 z1= 3 -.363422570507426E-04 0.000000000000000E+00 alpha(00000582)=0.000000000000000E+00 beta (00000583)=0.130039441099668E+02 gamma(00000583)=0.130039441099668E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.75160E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 583 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000583)=0.000000000000000E+00 beta (00000584)=0.135922229335978E+02 gamma(00000584)=0.135922229335978E+02 lr_calc_dens: Charge drift due to real space implementation = -0.60713E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 584 z1= 1 -.428063808527298E-04 0.000000000000000E+00 z1= 2 -.339046145437365E-02 0.000000000000000E+00 z1= 3 0.384887474466737E-04 0.000000000000000E+00 alpha(00000584)=0.000000000000000E+00 beta (00000585)=0.130199020681028E+02 gamma(00000585)=0.130199020681028E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.11936E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 585 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000585)=0.000000000000000E+00 beta (00000586)=0.135272324477661E+02 gamma(00000586)=0.135272324477661E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10006E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 586 z1= 1 0.438836683187820E-04 0.000000000000000E+00 z1= 2 0.340526134531336E-02 0.000000000000000E+00 z1= 3 -.408409540936465E-04 0.000000000000000E+00 alpha(00000586)=0.000000000000000E+00 beta (00000587)=0.130270756404317E+02 gamma(00000587)=0.130270756404317E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10679E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 587 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000587)=0.000000000000000E+00 beta (00000588)=0.135159195107996E+02 gamma(00000588)=0.135159195107996E+02 lr_calc_dens: Charge drift due to real space implementation = 0.15765E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 588 z1= 1 -.429028113747027E-04 0.000000000000000E+00 z1= 2 -.337796924416748E-02 0.000000000000000E+00 z1= 3 0.429370463667279E-04 0.000000000000000E+00 alpha(00000588)=0.000000000000000E+00 beta (00000589)=0.129055102639292E+02 gamma(00000589)=0.129055102639292E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.64476E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 589 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000589)=0.000000000000000E+00 beta (00000590)=0.136067487332855E+02 gamma(00000590)=0.136067487332855E+02 lr_calc_dens: Charge drift due to real space implementation = -0.37539E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 590 z1= 1 0.416955928583245E-04 0.000000000000000E+00 z1= 2 0.341305936942229E-02 0.000000000000000E+00 z1= 3 -.429927392563701E-04 0.000000000000000E+00 alpha(00000590)=0.000000000000000E+00 beta (00000591)=0.129919194963430E+02 gamma(00000591)=0.129919194963430E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.22264E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 591 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000591)=0.000000000000000E+00 beta (00000592)=0.134223761306262E+02 gamma(00000592)=0.134223761306262E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11447E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 592 z1= 1 -.446949196263677E-04 0.000000000000000E+00 z1= 2 -.372409015369378E-02 0.000000000000000E+00 z1= 3 0.430161681833960E-04 0.000000000000000E+00 alpha(00000592)=0.000000000000000E+00 beta (00000593)=0.130237757349898E+02 gamma(00000593)=0.130237757349898E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.71686E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 593 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000593)=0.000000000000000E+00 beta (00000594)=0.134438394705831E+02 gamma(00000594)=0.134438394705831E+02 lr_calc_dens: Charge drift due to real space implementation = -0.70718E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 594 z1= 1 0.451608687043388E-04 0.000000000000000E+00 z1= 2 0.415042533613645E-02 0.000000000000000E+00 z1= 3 -.429097225631220E-04 0.000000000000000E+00 alpha(00000594)=0.000000000000000E+00 beta (00000595)=0.129803000358835E+02 gamma(00000595)=0.129803000358835E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10900E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 595 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000595)=0.000000000000000E+00 beta (00000596)=0.133991681910812E+02 gamma(00000596)=0.133991681910812E+02 lr_calc_dens: Charge drift due to real space implementation = 0.79270E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 596 z1= 1 -.443255434055085E-04 0.000000000000000E+00 z1= 2 -.460161194116665E-02 0.000000000000000E+00 z1= 3 0.425309669921190E-04 0.000000000000000E+00 alpha(00000596)=0.000000000000000E+00 beta (00000597)=0.129873109772618E+02 gamma(00000597)=0.129873109772618E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.68815E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 597 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000597)=0.000000000000000E+00 beta (00000598)=0.135148757452556E+02 gamma(00000598)=0.135148757452556E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11967E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 598 z1= 1 0.413139445258471E-04 0.000000000000000E+00 z1= 2 0.476560284034453E-02 0.000000000000000E+00 z1= 3 -.415942263810775E-04 0.000000000000000E+00 alpha(00000598)=0.000000000000000E+00 beta (00000599)=0.129811729687592E+02 gamma(00000599)=0.129811729687592E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.21395E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 599 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000599)=0.000000000000000E+00 beta (00000600)=0.134127153555178E+02 gamma(00000600)=0.134127153555178E+02 lr_calc_dens: Charge drift due to real space implementation = 0.66124E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 600 z1= 1 -.403481897563616E-04 0.000000000000000E+00 z1= 2 -.457728849010593E-02 0.000000000000000E+00 z1= 3 0.398102094851860E-04 0.000000000000000E+00 alpha(00000600)=0.000000000000000E+00 beta (00000601)=0.129941805494786E+02 gamma(00000601)=0.129941805494786E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.57082E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 601 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000601)=0.000000000000000E+00 beta (00000602)=0.134002816639762E+02 gamma(00000602)=0.134002816639762E+02 lr_calc_dens: Charge drift due to real space implementation = 0.53221E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 602 z1= 1 0.399472205366437E-04 0.000000000000000E+00 z1= 2 0.405293235461524E-02 0.000000000000000E+00 z1= 3 -.379840679659175E-04 0.000000000000000E+00 alpha(00000602)=0.000000000000000E+00 beta (00000603)=0.130165198795565E+02 gamma(00000603)=0.130165198795565E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.27093E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 603 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000603)=0.000000000000000E+00 beta (00000604)=0.134103767511106E+02 gamma(00000604)=0.134103767511106E+02 lr_calc_dens: Charge drift due to real space implementation = -0.20982E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 604 z1= 1 -.383774349621692E-04 0.000000000000000E+00 z1= 2 -.337207964768515E-02 0.000000000000000E+00 z1= 3 0.366385866829074E-04 0.000000000000000E+00 alpha(00000604)=0.000000000000000E+00 beta (00000605)=0.129696013483834E+02 gamma(00000605)=0.129696013483834E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.24676E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 605 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000605)=0.000000000000000E+00 beta (00000606)=0.135127130038639E+02 gamma(00000606)=0.135127130038639E+02 lr_calc_dens: Charge drift due to real space implementation = 0.49482E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 606 z1= 1 0.382133640722728E-04 0.000000000000000E+00 z1= 2 0.268522176667442E-02 0.000000000000000E+00 z1= 3 -.351628905909686E-04 0.000000000000000E+00 alpha(00000606)=0.000000000000000E+00 beta (00000607)=0.130527046344413E+02 gamma(00000607)=0.130527046344413E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.69806E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 607 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000607)=0.000000000000000E+00 beta (00000608)=0.133968493026366E+02 gamma(00000608)=0.133968493026366E+02 lr_calc_dens: Charge drift due to real space implementation = -0.21049E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 608 z1= 1 -.387772341668212E-04 0.000000000000000E+00 z1= 2 -.215813033342774E-02 0.000000000000000E+00 z1= 3 0.342727600842721E-04 0.000000000000000E+00 alpha(00000608)=0.000000000000000E+00 beta (00000609)=0.129265336901399E+02 gamma(00000609)=0.129265336901399E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11153E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 609 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000609)=0.000000000000000E+00 beta (00000610)=0.134763124283549E+02 gamma(00000610)=0.134763124283549E+02 lr_calc_dens: Charge drift due to real space implementation = 0.71537E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 610 z1= 1 0.357402660476017E-04 0.000000000000000E+00 z1= 2 0.170716859314036E-02 0.000000000000000E+00 z1= 3 -.327876400714856E-04 0.000000000000000E+00 alpha(00000610)=0.000000000000000E+00 beta (00000611)=0.130780636726794E+02 gamma(00000611)=0.130780636726794E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.86844E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 611 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000611)=0.000000000000000E+00 beta (00000612)=0.134701149761540E+02 gamma(00000612)=0.134701149761540E+02 lr_calc_dens: Charge drift due to real space implementation = -0.54375E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 612 z1= 1 -.356770962621142E-04 0.000000000000000E+00 z1= 2 -.143154138497699E-02 0.000000000000000E+00 z1= 3 0.310739105566240E-04 0.000000000000000E+00 alpha(00000612)=0.000000000000000E+00 beta (00000613)=0.130852414859055E+02 gamma(00000613)=0.130852414859055E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.44939E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 613 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000613)=0.000000000000000E+00 beta (00000614)=0.135665454890162E+02 gamma(00000614)=0.135665454890162E+02 lr_calc_dens: Charge drift due to real space implementation = 0.92226E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 614 z1= 1 0.364039035623013E-04 0.000000000000000E+00 z1= 2 0.123533156841790E-02 0.000000000000000E+00 z1= 3 -.287726366949229E-04 0.000000000000000E+00 alpha(00000614)=0.000000000000000E+00 beta (00000615)=0.129849057006739E+02 gamma(00000615)=0.129849057006739E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.18073E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 615 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000615)=0.000000000000000E+00 beta (00000616)=0.134654887877342E+02 gamma(00000616)=0.134654887877342E+02 lr_calc_dens: Charge drift due to real space implementation = 0.30706E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 616 z1= 1 -.352869614455124E-04 0.000000000000000E+00 z1= 2 -.105759709263638E-02 0.000000000000000E+00 z1= 3 0.271575843063004E-04 0.000000000000000E+00 alpha(00000616)=0.000000000000000E+00 beta (00000617)=0.131413862438354E+02 gamma(00000617)=0.131413862438354E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.18525E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 617 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000617)=0.000000000000000E+00 beta (00000618)=0.135102151855217E+02 gamma(00000618)=0.135102151855217E+02 lr_calc_dens: Charge drift due to real space implementation = -0.17060E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 618 z1= 1 0.336696903651852E-04 0.000000000000000E+00 z1= 2 0.781537883297236E-03 0.000000000000000E+00 z1= 3 -.264203064837341E-04 0.000000000000000E+00 alpha(00000618)=0.000000000000000E+00 beta (00000619)=0.130668265788681E+02 gamma(00000619)=0.130668265788681E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.32234E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 619 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000619)=0.000000000000000E+00 beta (00000620)=0.135688556762090E+02 gamma(00000620)=0.135688556762090E+02 lr_calc_dens: Charge drift due to real space implementation = 0.14319E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 620 z1= 1 -.322765977419388E-04 0.000000000000000E+00 z1= 2 -.382921020130949E-03 0.000000000000000E+00 z1= 3 0.256402315610171E-04 0.000000000000000E+00 alpha(00000620)=0.000000000000000E+00 beta (00000621)=0.129863065629719E+02 gamma(00000621)=0.129863065629719E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.68947E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 621 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000621)=0.000000000000000E+00 beta (00000622)=0.134501017135930E+02 gamma(00000622)=0.134501017135930E+02 lr_calc_dens: Charge drift due to real space implementation = -0.44654E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 622 z1= 1 0.296257559326361E-04 0.000000000000000E+00 z1= 2 -.127846105821144E-04 0.000000000000000E+00 z1= 3 -.250706713260567E-04 0.000000000000000E+00 alpha(00000622)=0.000000000000000E+00 beta (00000623)=0.130025767431714E+02 gamma(00000623)=0.130025767431714E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.70311E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 623 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000623)=0.000000000000000E+00 beta (00000624)=0.134654650879064E+02 gamma(00000624)=0.134654650879064E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11687E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 624 z1= 1 -.289162574077552E-04 0.000000000000000E+00 z1= 2 0.313074719365392E-03 0.000000000000000E+00 z1= 3 0.246801725186554E-04 0.000000000000000E+00 alpha(00000624)=0.000000000000000E+00 beta (00000625)=0.129472235486185E+02 gamma(00000625)=0.129472235486185E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.54866E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 625 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000625)=0.000000000000000E+00 beta (00000626)=0.135020593463478E+02 gamma(00000626)=0.135020593463478E+02 lr_calc_dens: Charge drift due to real space implementation = 0.55702E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 626 z1= 1 0.312347895319726E-04 0.000000000000000E+00 z1= 2 -.395503245058336E-03 0.000000000000000E+00 z1= 3 -.247006078552799E-04 0.000000000000000E+00 alpha(00000626)=0.000000000000000E+00 beta (00000627)=0.130679894787644E+02 gamma(00000627)=0.130679894787644E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.65714E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 627 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000627)=0.000000000000000E+00 beta (00000628)=0.134444002349796E+02 gamma(00000628)=0.134444002349796E+02 lr_calc_dens: Charge drift due to real space implementation = -0.63195E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 628 z1= 1 -.303713521373327E-04 0.000000000000000E+00 z1= 2 0.354525156067396E-03 0.000000000000000E+00 z1= 3 0.264418708572168E-04 0.000000000000000E+00 alpha(00000628)=0.000000000000000E+00 beta (00000629)=0.130036349230019E+02 gamma(00000629)=0.130036349230019E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.56395E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 629 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000629)=0.000000000000000E+00 beta (00000630)=0.134626718267755E+02 gamma(00000630)=0.134626718267755E+02 lr_calc_dens: Charge drift due to real space implementation = 0.20541E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 630 z1= 1 0.307115654060806E-04 0.000000000000000E+00 z1= 2 -.331130759369984E-03 0.000000000000000E+00 z1= 3 -.290803847823154E-04 0.000000000000000E+00 alpha(00000630)=0.000000000000000E+00 beta (00000631)=0.130707892566566E+02 gamma(00000631)=0.130707892566566E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.74143E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 631 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000631)=0.000000000000000E+00 beta (00000632)=0.134709539209779E+02 gamma(00000632)=0.134709539209779E+02 lr_calc_dens: Charge drift due to real space implementation = -0.61386E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 632 z1= 1 -.304368391570338E-04 0.000000000000000E+00 z1= 2 0.264942165249617E-03 0.000000000000000E+00 z1= 3 0.320591956112069E-04 0.000000000000000E+00 alpha(00000632)=0.000000000000000E+00 beta (00000633)=0.129350764521232E+02 gamma(00000633)=0.129350764521232E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.95487E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 633 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000633)=0.000000000000000E+00 beta (00000634)=0.135178983618766E+02 gamma(00000634)=0.135178983618766E+02 lr_calc_dens: Charge drift due to real space implementation = -0.39196E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 634 z1= 1 0.286362080129145E-04 0.000000000000000E+00 z1= 2 -.433738067233905E-04 0.000000000000000E+00 z1= 3 -.338509959639157E-04 0.000000000000000E+00 alpha(00000634)=0.000000000000000E+00 beta (00000635)=0.130260653756797E+02 gamma(00000635)=0.130260653756797E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.59786E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 635 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000635)=0.000000000000000E+00 beta (00000636)=0.135311781683425E+02 gamma(00000636)=0.135311781683425E+02 lr_calc_dens: Charge drift due to real space implementation = 0.78568E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 636 z1= 1 -.292443526765853E-04 0.000000000000000E+00 z1= 2 -.231174124591062E-03 0.000000000000000E+00 z1= 3 0.369566650557976E-04 0.000000000000000E+00 alpha(00000636)=0.000000000000000E+00 beta (00000637)=0.130944607948813E+02 gamma(00000637)=0.130944607948813E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.73845E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 637 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000637)=0.000000000000000E+00 beta (00000638)=0.135004376248016E+02 gamma(00000638)=0.135004376248016E+02 lr_calc_dens: Charge drift due to real space implementation = 0.26155E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 638 z1= 1 0.304571919788315E-04 0.000000000000000E+00 z1= 2 0.403247066637962E-03 0.000000000000000E+00 z1= 3 -.403898750220319E-04 0.000000000000000E+00 alpha(00000638)=0.000000000000000E+00 beta (00000639)=0.130120511324955E+02 gamma(00000639)=0.130120511324955E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.15756E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 639 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000639)=0.000000000000000E+00 beta (00000640)=0.134398859716764E+02 gamma(00000640)=0.134398859716764E+02 lr_calc_dens: Charge drift due to real space implementation = 0.58275E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 640 z1= 1 -.298502678910937E-04 0.000000000000000E+00 z1= 2 -.305301815921682E-03 0.000000000000000E+00 z1= 3 0.444258752535795E-04 0.000000000000000E+00 alpha(00000640)=0.000000000000000E+00 beta (00000641)=0.130628774599876E+02 gamma(00000641)=0.130628774599876E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.14796E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 641 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000641)=0.000000000000000E+00 beta (00000642)=0.134873690430360E+02 gamma(00000642)=0.134873690430360E+02 lr_calc_dens: Charge drift due to real space implementation = -0.16960E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 642 z1= 1 0.294145113181410E-04 0.000000000000000E+00 z1= 2 0.803699510278357E-04 0.000000000000000E+00 z1= 3 -.474585097315605E-04 0.000000000000000E+00 alpha(00000642)=0.000000000000000E+00 beta (00000643)=0.131348654338483E+02 gamma(00000643)=0.131348654338483E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.55360E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 643 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000643)=0.000000000000000E+00 beta (00000644)=0.135370185360389E+02 gamma(00000644)=0.135370185360389E+02 lr_calc_dens: Charge drift due to real space implementation = 0.14866E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 644 z1= 1 -.297493353483757E-04 0.000000000000000E+00 z1= 2 0.566393386077215E-04 0.000000000000000E+00 z1= 3 0.515096535564259E-04 0.000000000000000E+00 alpha(00000644)=0.000000000000000E+00 beta (00000645)=0.129430510847189E+02 gamma(00000645)=0.129430510847189E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12720E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 645 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000645)=0.000000000000000E+00 beta (00000646)=0.134809407542147E+02 gamma(00000646)=0.134809407542147E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12896E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 646 z1= 1 0.308583531359854E-04 0.000000000000000E+00 z1= 2 0.439648251496921E-05 0.000000000000000E+00 z1= 3 -.546649410720812E-04 0.000000000000000E+00 alpha(00000646)=0.000000000000000E+00 beta (00000647)=0.130379980255779E+02 gamma(00000647)=0.130379980255779E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12372E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 647 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000647)=0.000000000000000E+00 beta (00000648)=0.134551227280756E+02 gamma(00000648)=0.134551227280756E+02 lr_calc_dens: Charge drift due to real space implementation = -0.15338E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 648 z1= 1 -.313624668057374E-04 0.000000000000000E+00 z1= 2 -.256896312393065E-03 0.000000000000000E+00 z1= 3 0.586485431526071E-04 0.000000000000000E+00 alpha(00000648)=0.000000000000000E+00 beta (00000649)=0.130344846837780E+02 gamma(00000649)=0.130344846837780E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.35141E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 649 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000649)=0.000000000000000E+00 beta (00000650)=0.135189926599560E+02 gamma(00000650)=0.135189926599560E+02 lr_calc_dens: Charge drift due to real space implementation = 0.16499E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 650 z1= 1 0.330711023211381E-04 0.000000000000000E+00 z1= 2 0.515870525814818E-03 0.000000000000000E+00 z1= 3 -.617634109083493E-04 0.000000000000000E+00 alpha(00000650)=0.000000000000000E+00 beta (00000651)=0.130101612427502E+02 gamma(00000651)=0.130101612427502E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.24413E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 651 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000651)=0.000000000000000E+00 beta (00000652)=0.134483827143525E+02 gamma(00000652)=0.134483827143525E+02 lr_calc_dens: Charge drift due to real space implementation = 0.43784E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 652 z1= 1 -.316920686089586E-04 0.000000000000000E+00 z1= 2 -.764774161488073E-03 0.000000000000000E+00 z1= 3 0.651517418876159E-04 0.000000000000000E+00 alpha(00000652)=0.000000000000000E+00 beta (00000653)=0.130496702688269E+02 gamma(00000653)=0.130496702688269E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.23799E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 653 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000653)=0.000000000000000E+00 beta (00000654)=0.135161539610003E+02 gamma(00000654)=0.135161539610003E+02 lr_calc_dens: Charge drift due to real space implementation = -0.22841E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 654 z1= 1 0.300410943223283E-04 0.000000000000000E+00 z1= 2 0.104019459344507E-02 0.000000000000000E+00 z1= 3 -.669592759419438E-04 0.000000000000000E+00 alpha(00000654)=0.000000000000000E+00 beta (00000655)=0.130256217583273E+02 gamma(00000655)=0.130256217583273E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.36860E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 655 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000655)=0.000000000000000E+00 beta (00000656)=0.134870208313763E+02 gamma(00000656)=0.134870208313763E+02 lr_calc_dens: Charge drift due to real space implementation = 0.18656E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 656 z1= 1 -.304886301611502E-04 0.000000000000000E+00 z1= 2 -.131240059311968E-02 0.000000000000000E+00 z1= 3 0.682831077315744E-04 0.000000000000000E+00 alpha(00000656)=0.000000000000000E+00 beta (00000657)=0.130726452985949E+02 gamma(00000657)=0.130726452985949E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.11073E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 657 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000657)=0.000000000000000E+00 beta (00000658)=0.135386152830110E+02 gamma(00000658)=0.135386152830110E+02 lr_calc_dens: Charge drift due to real space implementation = -0.52674E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 658 z1= 1 0.309222619886045E-04 0.000000000000000E+00 z1= 2 0.153876256619414E-02 0.000000000000000E+00 z1= 3 -.684800550481077E-04 0.000000000000000E+00 alpha(00000658)=0.000000000000000E+00 beta (00000659)=0.130169509633937E+02 gamma(00000659)=0.130169509633937E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.78525E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 659 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000659)=0.000000000000000E+00 beta (00000660)=0.134245340722607E+02 gamma(00000660)=0.134245340722607E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12491E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 660 z1= 1 -.333118178475703E-04 0.000000000000000E+00 z1= 2 -.177642013016846E-02 0.000000000000000E+00 z1= 3 0.686811154264625E-04 0.000000000000000E+00 alpha(00000660)=0.000000000000000E+00 beta (00000661)=0.129956220820540E+02 gamma(00000661)=0.129956220820540E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.71975E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 661 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000661)=0.000000000000000E+00 beta (00000662)=0.134690551787564E+02 gamma(00000662)=0.134690551787564E+02 lr_calc_dens: Charge drift due to real space implementation = 0.92843E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 662 z1= 1 0.339927288791186E-04 0.000000000000000E+00 z1= 2 0.208150106276750E-02 0.000000000000000E+00 z1= 3 -.675792870436559E-04 0.000000000000000E+00 alpha(00000662)=0.000000000000000E+00 beta (00000663)=0.129492836942786E+02 gamma(00000663)=0.129492836942786E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.19965E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 663 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000663)=0.000000000000000E+00 beta (00000664)=0.134745431723644E+02 gamma(00000664)=0.134745431723644E+02 lr_calc_dens: Charge drift due to real space implementation = 0.77097E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 664 z1= 1 -.365195533057871E-04 0.000000000000000E+00 z1= 2 -.227549550709501E-02 0.000000000000000E+00 z1= 3 0.656001950431890E-04 0.000000000000000E+00 alpha(00000664)=0.000000000000000E+00 beta (00000665)=0.130489153564532E+02 gamma(00000665)=0.130489153564532E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.15881E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 665 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000665)=0.000000000000000E+00 beta (00000666)=0.134411472378188E+02 gamma(00000666)=0.134411472378188E+02 lr_calc_dens: Charge drift due to real space implementation = -0.20496E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 666 z1= 1 0.361308614198544E-04 0.000000000000000E+00 z1= 2 0.237531077819789E-02 0.000000000000000E+00 z1= 3 -.634516133484019E-04 0.000000000000000E+00 alpha(00000666)=0.000000000000000E+00 beta (00000667)=0.129556478958720E+02 gamma(00000667)=0.129556478958720E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12767E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 667 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000667)=0.000000000000000E+00 beta (00000668)=0.134256776240573E+02 gamma(00000668)=0.134256776240573E+02 lr_calc_dens: Charge drift due to real space implementation = 0.15850E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 668 z1= 1 -.342367158824766E-04 0.000000000000000E+00 z1= 2 -.233849170377715E-02 0.000000000000000E+00 z1= 3 0.612068238537389E-04 0.000000000000000E+00 alpha(00000668)=0.000000000000000E+00 beta (00000669)=0.130245782008663E+02 gamma(00000669)=0.130245782008663E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12678E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 669 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000669)=0.000000000000000E+00 beta (00000670)=0.134577025236136E+02 gamma(00000670)=0.134577025236136E+02 lr_calc_dens: Charge drift due to real space implementation = -0.15819E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 670 z1= 1 0.345160925031909E-04 0.000000000000000E+00 z1= 2 0.216519713528084E-02 0.000000000000000E+00 z1= 3 -.589902961292390E-04 0.000000000000000E+00 alpha(00000670)=0.000000000000000E+00 beta (00000671)=0.130782304680844E+02 gamma(00000671)=0.130782304680844E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11082E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 671 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000671)=0.000000000000000E+00 beta (00000672)=0.135090375275362E+02 gamma(00000672)=0.135090375275362E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10905E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 672 z1= 1 -.363717438685365E-04 0.000000000000000E+00 z1= 2 -.199927221399980E-02 0.000000000000000E+00 z1= 3 0.569055903991232E-04 0.000000000000000E+00 alpha(00000672)=0.000000000000000E+00 beta (00000673)=0.130982162040802E+02 gamma(00000673)=0.130982162040802E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.19677E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 673 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000673)=0.000000000000000E+00 beta (00000674)=0.135295799215971E+02 gamma(00000674)=0.135295799215971E+02 lr_calc_dens: Charge drift due to real space implementation = 0.99181E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 674 z1= 1 0.403932459835058E-04 0.000000000000000E+00 z1= 2 0.182030676477667E-02 0.000000000000000E+00 z1= 3 -.553778768192628E-04 0.000000000000000E+00 alpha(00000674)=0.000000000000000E+00 beta (00000675)=0.129854079759881E+02 gamma(00000675)=0.129854079759881E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12893E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 675 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000675)=0.000000000000000E+00 beta (00000676)=0.134089058025188E+02 gamma(00000676)=0.134089058025188E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11406E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 676 z1= 1 -.433631830572736E-04 0.000000000000000E+00 z1= 2 -.157546396334631E-02 0.000000000000000E+00 z1= 3 0.542481277752232E-04 0.000000000000000E+00 alpha(00000676)=0.000000000000000E+00 beta (00000677)=0.130549438817556E+02 gamma(00000677)=0.130549438817556E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11459E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 677 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000677)=0.000000000000000E+00 beta (00000678)=0.134765780399335E+02 gamma(00000678)=0.134765780399335E+02 lr_calc_dens: Charge drift due to real space implementation = -0.81718E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 678 z1= 1 0.432592010599694E-04 0.000000000000000E+00 z1= 2 0.123749596807583E-02 0.000000000000000E+00 z1= 3 -.536443659161879E-04 0.000000000000000E+00 alpha(00000678)=0.000000000000000E+00 beta (00000679)=0.130418945180330E+02 gamma(00000679)=0.130418945180330E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.34247E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 679 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000679)=0.000000000000000E+00 beta (00000680)=0.133788752134771E+02 gamma(00000680)=0.133788752134771E+02 lr_calc_dens: Charge drift due to real space implementation = 0.50048E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 680 z1= 1 -.445277304263643E-04 0.000000000000000E+00 z1= 2 -.825940233889274E-03 0.000000000000000E+00 z1= 3 0.537582307810162E-04 0.000000000000000E+00 alpha(00000680)=0.000000000000000E+00 beta (00000681)=0.131270901510390E+02 gamma(00000681)=0.131270901510390E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.16566E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 681 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000681)=0.000000000000000E+00 beta (00000682)=0.134714583744286E+02 gamma(00000682)=0.134714583744286E+02 lr_calc_dens: Charge drift due to real space implementation = 0.18153E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 682 z1= 1 0.447310443524827E-04 0.000000000000000E+00 z1= 2 0.410963462914662E-03 0.000000000000000E+00 z1= 3 -.541396611424299E-04 0.000000000000000E+00 alpha(00000682)=0.000000000000000E+00 beta (00000683)=0.130659894257020E+02 gamma(00000683)=0.130659894257020E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.62460E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 683 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000683)=0.000000000000000E+00 beta (00000684)=0.134376679826735E+02 gamma(00000684)=0.134376679826735E+02 lr_calc_dens: Charge drift due to real space implementation = -0.92046E-10 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 684 z1= 1 -.469848537039659E-04 0.000000000000000E+00 z1= 2 -.538666242679694E-04 0.000000000000000E+00 z1= 3 0.548299797265769E-04 0.000000000000000E+00 alpha(00000684)=0.000000000000000E+00 beta (00000685)=0.130628166102177E+02 gamma(00000685)=0.130628166102177E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11781E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 685 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000685)=0.000000000000000E+00 beta (00000686)=0.133992593933832E+02 gamma(00000686)=0.133992593933832E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10306E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 686 z1= 1 0.465878388313046E-04 0.000000000000000E+00 z1= 2 -.146394147117736E-03 0.000000000000000E+00 z1= 3 -.556056506115979E-04 0.000000000000000E+00 alpha(00000686)=0.000000000000000E+00 beta (00000687)=0.131139875106630E+02 gamma(00000687)=0.131139875106630E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.58832E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 687 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000687)=0.000000000000000E+00 beta (00000688)=0.135285015037161E+02 gamma(00000688)=0.135285015037161E+02 lr_calc_dens: Charge drift due to real space implementation = 0.15075E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 688 z1= 1 -.473145548749159E-04 0.000000000000000E+00 z1= 2 0.191159209646107E-03 0.000000000000000E+00 z1= 3 0.565506359895046E-04 0.000000000000000E+00 alpha(00000688)=0.000000000000000E+00 beta (00000689)=0.131560451431090E+02 gamma(00000689)=0.131560451431090E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.55745E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 689 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000689)=0.000000000000000E+00 beta (00000690)=0.134005559230428E+02 gamma(00000690)=0.134005559230428E+02 lr_calc_dens: Charge drift due to real space implementation = -0.92224E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 690 z1= 1 0.511133081232207E-04 0.000000000000000E+00 z1= 2 -.216767096760626E-03 0.000000000000000E+00 z1= 3 -.579420236997493E-04 0.000000000000000E+00 alpha(00000690)=0.000000000000000E+00 beta (00000691)=0.130311229066974E+02 gamma(00000691)=0.130311229066974E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12356E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 691 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000691)=0.000000000000000E+00 beta (00000692)=0.134596162301023E+02 gamma(00000692)=0.134596162301023E+02 lr_calc_dens: Charge drift due to real space implementation = -0.31075E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 692 z1= 1 -.533302061200957E-04 0.000000000000000E+00 z1= 2 0.356798454154752E-03 0.000000000000000E+00 z1= 3 0.587169292292976E-04 0.000000000000000E+00 alpha(00000692)=0.000000000000000E+00 beta (00000693)=0.130720843081438E+02 gamma(00000693)=0.130720843081438E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.71909E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 693 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000693)=0.000000000000000E+00 beta (00000694)=0.134190250263858E+02 gamma(00000694)=0.134190250263858E+02 lr_calc_dens: Charge drift due to real space implementation = 0.81581E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 694 z1= 1 0.527152193963948E-04 0.000000000000000E+00 z1= 2 -.633614207454749E-03 0.000000000000000E+00 z1= 3 -.598800348937398E-04 0.000000000000000E+00 alpha(00000694)=0.000000000000000E+00 beta (00000695)=0.130649172833577E+02 gamma(00000695)=0.130649172833577E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.80294E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 695 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000695)=0.000000000000000E+00 beta (00000696)=0.134492780377847E+02 gamma(00000696)=0.134492780377847E+02 lr_calc_dens: Charge drift due to real space implementation = -0.91428E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 696 z1= 1 -.532871539753936E-04 0.000000000000000E+00 z1= 2 0.103752709045926E-02 0.000000000000000E+00 z1= 3 0.616278994181277E-04 0.000000000000000E+00 alpha(00000696)=0.000000000000000E+00 beta (00000697)=0.131175958773011E+02 gamma(00000697)=0.131175958773011E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.37090E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 697 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000697)=0.000000000000000E+00 beta (00000698)=0.135173788152955E+02 gamma(00000698)=0.135173788152955E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11937E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 698 z1= 1 0.560347941695801E-04 0.000000000000000E+00 z1= 2 -.159710505729098E-02 0.000000000000000E+00 z1= 3 -.620171791808102E-04 0.000000000000000E+00 alpha(00000698)=0.000000000000000E+00 beta (00000699)=0.131306216799322E+02 gamma(00000699)=0.131306216799322E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.15553E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 699 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000699)=0.000000000000000E+00 beta (00000700)=0.133529048037636E+02 gamma(00000700)=0.133529048037636E+02 lr_calc_dens: Charge drift due to real space implementation = -0.20324E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 700 z1= 1 -.575197912933362E-04 0.000000000000000E+00 z1= 2 0.224934651751471E-02 0.000000000000000E+00 z1= 3 0.638955800410508E-04 0.000000000000000E+00 alpha(00000700)=0.000000000000000E+00 beta (00000701)=0.130754546204528E+02 gamma(00000701)=0.130754546204528E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.18525E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 701 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000701)=0.000000000000000E+00 beta (00000702)=0.134114781532151E+02 gamma(00000702)=0.134114781532151E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10491E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 702 z1= 1 0.572686159499652E-04 0.000000000000000E+00 z1= 2 -.286795604175203E-02 0.000000000000000E+00 z1= 3 -.641472406112616E-04 0.000000000000000E+00 alpha(00000702)=0.000000000000000E+00 beta (00000703)=0.130896353315248E+02 gamma(00000703)=0.130896353315248E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.99596E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 703 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000703)=0.000000000000000E+00 beta (00000704)=0.134069833820909E+02 gamma(00000704)=0.134069833820909E+02 lr_calc_dens: Charge drift due to real space implementation = 0.13578E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 704 z1= 1 -.601274373466651E-04 0.000000000000000E+00 z1= 2 0.333690532610304E-02 0.000000000000000E+00 z1= 3 0.647582255021512E-04 0.000000000000000E+00 alpha(00000704)=0.000000000000000E+00 beta (00000705)=0.131346282253937E+02 gamma(00000705)=0.131346282253937E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14620E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 705 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000705)=0.000000000000000E+00 beta (00000706)=0.134784621225614E+02 gamma(00000706)=0.134784621225614E+02 lr_calc_dens: Charge drift due to real space implementation = -0.48120E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 706 z1= 1 0.633821632648806E-04 0.000000000000000E+00 z1= 2 -.363125704824767E-02 0.000000000000000E+00 z1= 3 -.636952074557401E-04 0.000000000000000E+00 alpha(00000706)=0.000000000000000E+00 beta (00000707)=0.130473998145775E+02 gamma(00000707)=0.130473998145775E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.14129E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 707 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000707)=0.000000000000000E+00 beta (00000708)=0.134406543038761E+02 gamma(00000708)=0.134406543038761E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10349E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 708 z1= 1 -.643539403503285E-04 0.000000000000000E+00 z1= 2 0.388731230420830E-02 0.000000000000000E+00 z1= 3 0.629742093867764E-04 0.000000000000000E+00 alpha(00000708)=0.000000000000000E+00 beta (00000709)=0.130010595043256E+02 gamma(00000709)=0.130010595043256E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.26637E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 709 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000709)=0.000000000000000E+00 beta (00000710)=0.133401975984556E+02 gamma(00000710)=0.133401975984556E+02 lr_calc_dens: Charge drift due to real space implementation = -0.17354E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 710 z1= 1 0.654043138267214E-04 0.000000000000000E+00 z1= 2 -.429866047275479E-02 0.000000000000000E+00 z1= 3 -.613730335019250E-04 0.000000000000000E+00 alpha(00000710)=0.000000000000000E+00 beta (00000711)=0.130380705888637E+02 gamma(00000711)=0.130380705888637E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12868E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 711 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000711)=0.000000000000000E+00 beta (00000712)=0.134397945788414E+02 gamma(00000712)=0.134397945788414E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10566E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 712 z1= 1 -.656836600207433E-04 0.000000000000000E+00 z1= 2 0.486822999899511E-02 0.000000000000000E+00 z1= 3 0.598558586669330E-04 0.000000000000000E+00 alpha(00000712)=0.000000000000000E+00 beta (00000713)=0.130821888746903E+02 gamma(00000713)=0.130821888746903E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.37347E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 713 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000713)=0.000000000000000E+00 beta (00000714)=0.134295520758732E+02 gamma(00000714)=0.134295520758732E+02 lr_calc_dens: Charge drift due to real space implementation = 0.19686E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 714 z1= 1 0.673576807552392E-04 0.000000000000000E+00 z1= 2 -.550535880527182E-02 0.000000000000000E+00 z1= 3 -.570506673321400E-04 0.000000000000000E+00 alpha(00000714)=0.000000000000000E+00 beta (00000715)=0.131438646945969E+02 gamma(00000715)=0.131438646945969E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.78724E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 715 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000715)=0.000000000000000E+00 beta (00000716)=0.133143159676078E+02 gamma(00000716)=0.133143159676078E+02 lr_calc_dens: Charge drift due to real space implementation = 0.15586E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 716 z1= 1 -.707003176353554E-04 0.000000000000000E+00 z1= 2 0.611139094796778E-02 0.000000000000000E+00 z1= 3 0.561367395770849E-04 0.000000000000000E+00 alpha(00000716)=0.000000000000000E+00 beta (00000717)=0.129972977739008E+02 gamma(00000717)=0.129972977739008E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.86248E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 717 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000717)=0.000000000000000E+00 beta (00000718)=0.134452548144904E+02 gamma(00000718)=0.134452548144904E+02 lr_calc_dens: Charge drift due to real space implementation = -0.75153E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 718 z1= 1 0.728799767411564E-04 0.000000000000000E+00 z1= 2 -.646196413226522E-02 0.000000000000000E+00 z1= 3 -.540870548791359E-04 0.000000000000000E+00 alpha(00000718)=0.000000000000000E+00 beta (00000719)=0.130290161630664E+02 gamma(00000719)=0.130290161630664E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11603E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 719 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000719)=0.000000000000000E+00 beta (00000720)=0.134264823172776E+02 gamma(00000720)=0.134264823172776E+02 lr_calc_dens: Charge drift due to real space implementation = 0.34192E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 720 z1= 1 -.722219839895816E-04 0.000000000000000E+00 z1= 2 0.670116903830124E-02 0.000000000000000E+00 z1= 3 0.538408461745243E-04 0.000000000000000E+00 alpha(00000720)=0.000000000000000E+00 beta (00000721)=0.130488515153629E+02 gamma(00000721)=0.130488515153629E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.24330E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 721 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000721)=0.000000000000000E+00 beta (00000722)=0.134124318053946E+02 gamma(00000722)=0.134124318053946E+02 lr_calc_dens: Charge drift due to real space implementation = 0.27846E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 722 z1= 1 0.738369696983293E-04 0.000000000000000E+00 z1= 2 -.687068517765595E-02 0.000000000000000E+00 z1= 3 -.532468774146290E-04 0.000000000000000E+00 alpha(00000722)=0.000000000000000E+00 beta (00000723)=0.131464108546636E+02 gamma(00000723)=0.131464108546636E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.85618E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 723 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000723)=0.000000000000000E+00 beta (00000724)=0.134705983939931E+02 gamma(00000724)=0.134705983939931E+02 lr_calc_dens: Charge drift due to real space implementation = 0.20000E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 724 z1= 1 -.731791919117986E-04 0.000000000000000E+00 z1= 2 0.711079217430166E-02 0.000000000000000E+00 z1= 3 0.539127726297730E-04 0.000000000000000E+00 alpha(00000724)=0.000000000000000E+00 beta (00000725)=0.130784658984954E+02 gamma(00000725)=0.130784658984954E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.68786E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 725 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000725)=0.000000000000000E+00 beta (00000726)=0.134706672777960E+02 gamma(00000726)=0.134706672777960E+02 lr_calc_dens: Charge drift due to real space implementation = -0.32525E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 726 z1= 1 0.741880988084798E-04 0.000000000000000E+00 z1= 2 -.726444136946329E-02 0.000000000000000E+00 z1= 3 -.530244626154169E-04 0.000000000000000E+00 alpha(00000726)=0.000000000000000E+00 beta (00000727)=0.131813177352877E+02 gamma(00000727)=0.131813177352877E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.47092E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 727 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000727)=0.000000000000000E+00 beta (00000728)=0.134632406707476E+02 gamma(00000728)=0.134632406707476E+02 lr_calc_dens: Charge drift due to real space implementation = 0.28092E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 728 z1= 1 -.735083579484555E-04 0.000000000000000E+00 z1= 2 0.736171481369465E-02 0.000000000000000E+00 z1= 3 0.532028049956700E-04 0.000000000000000E+00 alpha(00000728)=0.000000000000000E+00 beta (00000729)=0.130754596745506E+02 gamma(00000729)=0.130754596745506E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.39590E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 729 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000729)=0.000000000000000E+00 beta (00000730)=0.134138209730115E+02 gamma(00000730)=0.134138209730115E+02 lr_calc_dens: Charge drift due to real space implementation = -0.21076E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 730 z1= 1 0.751578625585361E-04 0.000000000000000E+00 z1= 2 -.736180562480418E-02 0.000000000000000E+00 z1= 3 -.524824108680942E-04 0.000000000000000E+00 alpha(00000730)=0.000000000000000E+00 beta (00000731)=0.131421671919996E+02 gamma(00000731)=0.131421671919996E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.48292E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 731 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000731)=0.000000000000000E+00 beta (00000732)=0.134812420309991E+02 gamma(00000732)=0.134812420309991E+02 lr_calc_dens: Charge drift due to real space implementation = 0.29481E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 732 z1= 1 -.736272637444795E-04 0.000000000000000E+00 z1= 2 0.727471952897485E-02 0.000000000000000E+00 z1= 3 0.522704771757027E-04 0.000000000000000E+00 alpha(00000732)=0.000000000000000E+00 beta (00000733)=0.131558550189735E+02 gamma(00000733)=0.131558550189735E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.48730E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 733 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000733)=0.000000000000000E+00 beta (00000734)=0.135277115702161E+02 gamma(00000734)=0.135277115702161E+02 lr_calc_dens: Charge drift due to real space implementation = -0.48810E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 734 z1= 1 0.731241593092168E-04 0.000000000000000E+00 z1= 2 -.708854514174848E-02 0.000000000000000E+00 z1= 3 -.511772494803359E-04 0.000000000000000E+00 alpha(00000734)=0.000000000000000E+00 beta (00000735)=0.131268551579852E+02 gamma(00000735)=0.131268551579852E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.23106E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 735 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000735)=0.000000000000000E+00 beta (00000736)=0.134586514787881E+02 gamma(00000736)=0.134586514787881E+02 lr_calc_dens: Charge drift due to real space implementation = 0.38892E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 736 z1= 1 -.739186283480898E-04 0.000000000000000E+00 z1= 2 0.692251972996668E-02 0.000000000000000E+00 z1= 3 0.499732008584374E-04 0.000000000000000E+00 alpha(00000736)=0.000000000000000E+00 beta (00000737)=0.131109011527096E+02 gamma(00000737)=0.131109011527096E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.50144E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 737 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000737)=0.000000000000000E+00 beta (00000738)=0.134281063486605E+02 gamma(00000738)=0.134281063486605E+02 lr_calc_dens: Charge drift due to real space implementation = 0.29094E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 738 z1= 1 0.744669531499622E-04 0.000000000000000E+00 z1= 2 -.685814967048222E-02 0.000000000000000E+00 z1= 3 -.483806223027691E-04 0.000000000000000E+00 alpha(00000738)=0.000000000000000E+00 beta (00000739)=0.131200444145268E+02 gamma(00000739)=0.131200444145268E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.51112E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 739 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000739)=0.000000000000000E+00 beta (00000740)=0.134130239375036E+02 gamma(00000740)=0.134130239375036E+02 lr_calc_dens: Charge drift due to real space implementation = -0.26210E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 740 z1= 1 -.770044468005751E-04 0.000000000000000E+00 z1= 2 0.688827149361244E-02 0.000000000000000E+00 z1= 3 0.472651522183433E-04 0.000000000000000E+00 alpha(00000740)=0.000000000000000E+00 beta (00000741)=0.130974541488982E+02 gamma(00000741)=0.130974541488982E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.89320E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 741 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000741)=0.000000000000000E+00 beta (00000742)=0.134524506003597E+02 gamma(00000742)=0.134524506003597E+02 lr_calc_dens: Charge drift due to real space implementation = -0.17009E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 742 z1= 1 0.799341708716903E-04 0.000000000000000E+00 z1= 2 -.687931578249102E-02 0.000000000000000E+00 z1= 3 -.450479844299785E-04 0.000000000000000E+00 alpha(00000742)=0.000000000000000E+00 beta (00000743)=0.129935623167294E+02 gamma(00000743)=0.129935623167294E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.70122E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 743 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000743)=0.000000000000000E+00 beta (00000744)=0.133351652491725E+02 gamma(00000744)=0.133351652491725E+02 lr_calc_dens: Charge drift due to real space implementation = 0.13280E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 744 z1= 1 -.804057195156849E-04 0.000000000000000E+00 z1= 2 0.679275946940251E-02 0.000000000000000E+00 z1= 3 0.436805777718056E-04 0.000000000000000E+00 alpha(00000744)=0.000000000000000E+00 beta (00000745)=0.131286885228194E+02 gamma(00000745)=0.131286885228194E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.97865E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 745 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000745)=0.000000000000000E+00 beta (00000746)=0.134063072030843E+02 gamma(00000746)=0.134063072030843E+02 lr_calc_dens: Charge drift due to real space implementation = -0.68753E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 746 z1= 1 0.797606058941043E-04 0.000000000000000E+00 z1= 2 -.666376422798378E-02 0.000000000000000E+00 z1= 3 -.429849879705709E-04 0.000000000000000E+00 alpha(00000746)=0.000000000000000E+00 beta (00000747)=0.130345827622622E+02 gamma(00000747)=0.130345827622622E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.60424E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 747 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000747)=0.000000000000000E+00 beta (00000748)=0.134220992741602E+02 gamma(00000748)=0.134220992741602E+02 lr_calc_dens: Charge drift due to real space implementation = 0.72995E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 748 z1= 1 -.791552168139999E-04 0.000000000000000E+00 z1= 2 0.637167761359639E-02 0.000000000000000E+00 z1= 3 0.427450877401930E-04 0.000000000000000E+00 alpha(00000748)=0.000000000000000E+00 beta (00000749)=0.130275399219193E+02 gamma(00000749)=0.130275399219193E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.33400E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 749 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000749)=0.000000000000000E+00 beta (00000750)=0.133622102323252E+02 gamma(00000750)=0.133622102323252E+02 lr_calc_dens: Charge drift due to real space implementation = -0.63365E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 750 z1= 1 0.788320777311536E-04 0.000000000000000E+00 z1= 2 -.601537158969427E-02 0.000000000000000E+00 z1= 3 -.429202918342789E-04 0.000000000000000E+00 alpha(00000750)=0.000000000000000E+00 beta (00000751)=0.131007714920256E+02 gamma(00000751)=0.131007714920256E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.17574E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 751 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000751)=0.000000000000000E+00 beta (00000752)=0.134668236326415E+02 gamma(00000752)=0.134668236326415E+02 lr_calc_dens: Charge drift due to real space implementation = 0.62622E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 752 z1= 1 -.795469471469258E-04 0.000000000000000E+00 z1= 2 0.558958270124907E-02 0.000000000000000E+00 z1= 3 0.440739383121220E-04 0.000000000000000E+00 alpha(00000752)=0.000000000000000E+00 beta (00000753)=0.130102265790300E+02 gamma(00000753)=0.130102265790300E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.26969E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 753 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000753)=0.000000000000000E+00 beta (00000754)=0.133937975913596E+02 gamma(00000754)=0.133937975913596E+02 lr_calc_dens: Charge drift due to real space implementation = 0.87925E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 754 z1= 1 0.771682909959928E-04 0.000000000000000E+00 z1= 2 -.515833508289116E-02 0.000000000000000E+00 z1= 3 -.458048524596600E-04 0.000000000000000E+00 alpha(00000754)=0.000000000000000E+00 beta (00000755)=0.130182807145871E+02 gamma(00000755)=0.130182807145871E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.22080E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 755 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000755)=0.000000000000000E+00 beta (00000756)=0.134838256618580E+02 gamma(00000756)=0.134838256618580E+02 lr_calc_dens: Charge drift due to real space implementation = -0.18123E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 756 z1= 1 -.724702410957439E-04 0.000000000000000E+00 z1= 2 0.469328167108058E-02 0.000000000000000E+00 z1= 3 0.482789375423572E-04 0.000000000000000E+00 alpha(00000756)=0.000000000000000E+00 beta (00000757)=0.131282656039827E+02 gamma(00000757)=0.131282656039827E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.72627E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 757 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000757)=0.000000000000000E+00 beta (00000758)=0.134474898512094E+02 gamma(00000758)=0.134474898512094E+02 lr_calc_dens: Charge drift due to real space implementation = -0.25542E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 758 z1= 1 0.683130799896785E-04 0.000000000000000E+00 z1= 2 -.437708844490365E-02 0.000000000000000E+00 z1= 3 -.509606607461570E-04 0.000000000000000E+00 alpha(00000758)=0.000000000000000E+00 beta (00000759)=0.131078140025281E+02 gamma(00000759)=0.131078140025281E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.60515E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 759 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000759)=0.000000000000000E+00 beta (00000760)=0.134293275832391E+02 gamma(00000760)=0.134293275832391E+02 lr_calc_dens: Charge drift due to real space implementation = 0.31117E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 760 z1= 1 -.654944029193395E-04 0.000000000000000E+00 z1= 2 0.426867746547832E-02 0.000000000000000E+00 z1= 3 0.549693108916359E-04 0.000000000000000E+00 alpha(00000760)=0.000000000000000E+00 beta (00000761)=0.130195589036474E+02 gamma(00000761)=0.130195589036474E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.67023E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 761 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000761)=0.000000000000000E+00 beta (00000762)=0.135104456788267E+02 gamma(00000762)=0.135104456788267E+02 lr_calc_dens: Charge drift due to real space implementation = -0.59317E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 762 z1= 1 0.594950509874327E-04 0.000000000000000E+00 z1= 2 -.416423729920910E-02 0.000000000000000E+00 z1= 3 -.569798409109035E-04 0.000000000000000E+00 alpha(00000762)=0.000000000000000E+00 beta (00000763)=0.132065726246999E+02 gamma(00000763)=0.132065726246999E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.27290E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 763 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000763)=0.000000000000000E+00 beta (00000764)=0.133875492509717E+02 gamma(00000764)=0.133875492509717E+02 lr_calc_dens: Charge drift due to real space implementation = 0.53284E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 764 z1= 1 -.578300729564760E-04 0.000000000000000E+00 z1= 2 0.401995110283460E-02 0.000000000000000E+00 z1= 3 0.598770461775485E-04 0.000000000000000E+00 alpha(00000764)=0.000000000000000E+00 beta (00000765)=0.131074858845292E+02 gamma(00000765)=0.131074858845292E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.34996E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 765 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000765)=0.000000000000000E+00 beta (00000766)=0.134649172374546E+02 gamma(00000766)=0.134649172374546E+02 lr_calc_dens: Charge drift due to real space implementation = 0.35941E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 766 z1= 1 0.539826599709348E-04 0.000000000000000E+00 z1= 2 -.359495171368003E-02 0.000000000000000E+00 z1= 3 -.601721895147350E-04 0.000000000000000E+00 alpha(00000766)=0.000000000000000E+00 beta (00000767)=0.130517781497578E+02 gamma(00000767)=0.130517781497578E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.55182E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 767 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000767)=0.000000000000000E+00 beta (00000768)=0.134309034969781E+02 gamma(00000768)=0.134309034969781E+02 lr_calc_dens: Charge drift due to real space implementation = -0.81924E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 768 z1= 1 -.521750506859413E-04 0.000000000000000E+00 z1= 2 0.307441291551782E-02 0.000000000000000E+00 z1= 3 0.593427147037671E-04 0.000000000000000E+00 alpha(00000768)=0.000000000000000E+00 beta (00000769)=0.131407424983398E+02 gamma(00000769)=0.131407424983398E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10521E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 769 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000769)=0.000000000000000E+00 beta (00000770)=0.134586739950534E+02 gamma(00000770)=0.134586739950534E+02 lr_calc_dens: Charge drift due to real space implementation = 0.15639E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 770 z1= 1 0.507886053088616E-04 0.000000000000000E+00 z1= 2 -.259627049667940E-02 0.000000000000000E+00 z1= 3 -.583288301688890E-04 0.000000000000000E+00 alpha(00000770)=0.000000000000000E+00 beta (00000771)=0.131221041282003E+02 gamma(00000771)=0.131221041282003E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14642E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 771 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000771)=0.000000000000000E+00 beta (00000772)=0.134382298162917E+02 gamma(00000772)=0.134382298162917E+02 lr_calc_dens: Charge drift due to real space implementation = 0.85764E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 772 z1= 1 -.497297063177162E-04 0.000000000000000E+00 z1= 2 0.229256466776942E-02 0.000000000000000E+00 z1= 3 0.571289776876321E-04 0.000000000000000E+00 alpha(00000772)=0.000000000000000E+00 beta (00000773)=0.130352476179736E+02 gamma(00000773)=0.130352476179736E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.80819E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 773 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000773)=0.000000000000000E+00 beta (00000774)=0.134148728791009E+02 gamma(00000774)=0.134148728791009E+02 lr_calc_dens: Charge drift due to real space implementation = -0.74675E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 774 z1= 1 0.443806589649712E-04 0.000000000000000E+00 z1= 2 -.225566390789850E-02 0.000000000000000E+00 z1= 3 -.557956759430515E-04 0.000000000000000E+00 alpha(00000774)=0.000000000000000E+00 beta (00000775)=0.130716504471898E+02 gamma(00000775)=0.130716504471898E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.46534E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 775 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000775)=0.000000000000000E+00 beta (00000776)=0.134170330063516E+02 gamma(00000776)=0.134170330063516E+02 lr_calc_dens: Charge drift due to real space implementation = 0.93971E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 776 z1= 1 -.438604577406906E-04 0.000000000000000E+00 z1= 2 0.244507655225910E-02 0.000000000000000E+00 z1= 3 0.541539804187590E-04 0.000000000000000E+00 alpha(00000776)=0.000000000000000E+00 beta (00000777)=0.131391247334133E+02 gamma(00000777)=0.131391247334133E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10553E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 777 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000777)=0.000000000000000E+00 beta (00000778)=0.134671670622590E+02 gamma(00000778)=0.134671670622590E+02 lr_calc_dens: Charge drift due to real space implementation = -0.26585E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 778 z1= 1 0.425071868662870E-04 0.000000000000000E+00 z1= 2 -.266781468168573E-02 0.000000000000000E+00 z1= 3 -.512221070768680E-04 0.000000000000000E+00 alpha(00000778)=0.000000000000000E+00 beta (00000779)=0.130504794298696E+02 gamma(00000779)=0.130504794298696E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14207E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 779 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000779)=0.000000000000000E+00 beta (00000780)=0.134479869976958E+02 gamma(00000780)=0.134479869976958E+02 lr_calc_dens: Charge drift due to real space implementation = 0.99580E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 780 z1= 1 -.389460262755874E-04 0.000000000000000E+00 z1= 2 0.280983540698413E-02 0.000000000000000E+00 z1= 3 0.478277041347705E-04 0.000000000000000E+00 alpha(00000780)=0.000000000000000E+00 beta (00000781)=0.129805120867735E+02 gamma(00000781)=0.129805120867735E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.91616E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 781 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000781)=0.000000000000000E+00 beta (00000782)=0.133744612587009E+02 gamma(00000782)=0.133744612587009E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12468E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 782 z1= 1 0.356714001081629E-04 0.000000000000000E+00 z1= 2 -.286452493403981E-02 0.000000000000000E+00 z1= 3 -.438432435163516E-04 0.000000000000000E+00 alpha(00000782)=0.000000000000000E+00 beta (00000783)=0.131810477297151E+02 gamma(00000783)=0.131810477297151E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.31535E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 783 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000783)=0.000000000000000E+00 beta (00000784)=0.134357287831426E+02 gamma(00000784)=0.134357287831426E+02 lr_calc_dens: Charge drift due to real space implementation = 0.13534E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 784 z1= 1 -.319361873982746E-04 0.000000000000000E+00 z1= 2 0.299027568947714E-02 0.000000000000000E+00 z1= 3 0.401294314887264E-04 0.000000000000000E+00 alpha(00000784)=0.000000000000000E+00 beta (00000785)=0.130681056164123E+02 gamma(00000785)=0.130681056164123E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.69291E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 785 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000785)=0.000000000000000E+00 beta (00000786)=0.134885651188699E+02 gamma(00000786)=0.134885651188699E+02 lr_calc_dens: Charge drift due to real space implementation = -0.51288E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 786 z1= 1 0.284122110488462E-04 0.000000000000000E+00 z1= 2 -.320266500752359E-02 0.000000000000000E+00 z1= 3 -.359476744643093E-04 0.000000000000000E+00 alpha(00000786)=0.000000000000000E+00 beta (00000787)=0.130120362656870E+02 gamma(00000787)=0.130120362656870E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10122E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 787 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000787)=0.000000000000000E+00 beta (00000788)=0.134159517564131E+02 gamma(00000788)=0.134159517564131E+02 lr_calc_dens: Charge drift due to real space implementation = -0.66782E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 788 z1= 1 -.240730097449179E-04 0.000000000000000E+00 z1= 2 0.352180288395699E-02 0.000000000000000E+00 z1= 3 0.317736006348603E-04 0.000000000000000E+00 alpha(00000788)=0.000000000000000E+00 beta (00000789)=0.130964909151915E+02 gamma(00000789)=0.130964909151915E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10893E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 789 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000789)=0.000000000000000E+00 beta (00000790)=0.134511175864931E+02 gamma(00000790)=0.134511175864931E+02 lr_calc_dens: Charge drift due to real space implementation = 0.94910E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 790 z1= 1 0.211614288408227E-04 0.000000000000000E+00 z1= 2 -.397089604896661E-02 0.000000000000000E+00 z1= 3 -.285489478152933E-04 0.000000000000000E+00 alpha(00000790)=0.000000000000000E+00 beta (00000791)=0.130137286718495E+02 gamma(00000791)=0.130137286718495E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.11832E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 791 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000791)=0.000000000000000E+00 beta (00000792)=0.134313736515619E+02 gamma(00000792)=0.134313736515619E+02 lr_calc_dens: Charge drift due to real space implementation = 0.88292E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 792 z1= 1 -.203591779261991E-04 0.000000000000000E+00 z1= 2 0.441594034605796E-02 0.000000000000000E+00 z1= 3 0.262443919904968E-04 0.000000000000000E+00 alpha(00000792)=0.000000000000000E+00 beta (00000793)=0.131576183122091E+02 gamma(00000793)=0.131576183122091E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12976E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 793 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000793)=0.000000000000000E+00 beta (00000794)=0.135345134359518E+02 gamma(00000794)=0.135345134359518E+02 lr_calc_dens: Charge drift due to real space implementation = -0.93490E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 794 z1= 1 0.173431589533223E-04 0.000000000000000E+00 z1= 2 -.475286355674562E-02 0.000000000000000E+00 z1= 3 -.247832705095255E-04 0.000000000000000E+00 alpha(00000794)=0.000000000000000E+00 beta (00000795)=0.130337343919525E+02 gamma(00000795)=0.130337343919525E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.67244E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 795 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000795)=0.000000000000000E+00 beta (00000796)=0.134785940463541E+02 gamma(00000796)=0.134785940463541E+02 lr_calc_dens: Charge drift due to real space implementation = 0.89171E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 796 z1= 1 -.137586409292012E-04 0.000000000000000E+00 z1= 2 0.493533112828103E-02 0.000000000000000E+00 z1= 3 0.243013324611437E-04 0.000000000000000E+00 alpha(00000796)=0.000000000000000E+00 beta (00000797)=0.130097077211047E+02 gamma(00000797)=0.130097077211047E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.40852E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 797 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000797)=0.000000000000000E+00 beta (00000798)=0.134595999908823E+02 gamma(00000798)=0.134595999908823E+02 lr_calc_dens: Charge drift due to real space implementation = -0.79714E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 798 z1= 1 0.118822286538749E-04 0.000000000000000E+00 z1= 2 -.502879118864333E-02 0.000000000000000E+00 z1= 3 -.241566739776885E-04 0.000000000000000E+00 alpha(00000798)=0.000000000000000E+00 beta (00000799)=0.130735931487812E+02 gamma(00000799)=0.130735931487812E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.94540E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 799 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000799)=0.000000000000000E+00 beta (00000800)=0.134553513990608E+02 gamma(00000800)=0.134553513990608E+02 lr_calc_dens: Charge drift due to real space implementation = 0.45429E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 800 z1= 1 -.736766709751729E-05 0.000000000000000E+00 z1= 2 0.513368654336077E-02 0.000000000000000E+00 z1= 3 0.245310323331972E-04 0.000000000000000E+00 alpha(00000800)=0.000000000000000E+00 beta (00000801)=0.130144197219657E+02 gamma(00000801)=0.130144197219657E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.86356E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 801 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000801)=0.000000000000000E+00 beta (00000802)=0.135694991012862E+02 gamma(00000802)=0.135694991012862E+02 lr_calc_dens: Charge drift due to real space implementation = -0.87480E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 802 z1= 1 0.733451050237942E-05 0.000000000000000E+00 z1= 2 -.515044718486823E-02 0.000000000000000E+00 z1= 3 -.234464098874719E-04 0.000000000000000E+00 alpha(00000802)=0.000000000000000E+00 beta (00000803)=0.129935925687678E+02 gamma(00000803)=0.129935925687678E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.91334E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 803 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000803)=0.000000000000000E+00 beta (00000804)=0.133825540957530E+02 gamma(00000804)=0.133825540957530E+02 lr_calc_dens: Charge drift due to real space implementation = -0.31018E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 804 z1= 1 -.539311188789242E-05 0.000000000000000E+00 z1= 2 0.509948381830053E-02 0.000000000000000E+00 z1= 3 0.235457320499690E-04 0.000000000000000E+00 alpha(00000804)=0.000000000000000E+00 beta (00000805)=0.130683790484435E+02 gamma(00000805)=0.130683790484435E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.71961E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 805 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000805)=0.000000000000000E+00 beta (00000806)=0.134677715030268E+02 gamma(00000806)=0.134677715030268E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10029E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 806 z1= 1 0.405703695538148E-05 0.000000000000000E+00 z1= 2 -.486062093853367E-02 0.000000000000000E+00 z1= 3 -.230171356652174E-04 0.000000000000000E+00 alpha(00000806)=0.000000000000000E+00 beta (00000807)=0.130807353540448E+02 gamma(00000807)=0.130807353540448E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10020E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 807 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000807)=0.000000000000000E+00 beta (00000808)=0.134457242929280E+02 gamma(00000808)=0.134457242929280E+02 lr_calc_dens: Charge drift due to real space implementation = 0.88076E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 808 z1= 1 0.667197209665467E-06 0.000000000000000E+00 z1= 2 0.446462274111020E-02 0.000000000000000E+00 z1= 3 0.227861182508904E-04 0.000000000000000E+00 alpha(00000808)=0.000000000000000E+00 beta (00000809)=0.130624288958255E+02 gamma(00000809)=0.130624288958255E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.41971E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 809 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000809)=0.000000000000000E+00 beta (00000810)=0.134548460041203E+02 gamma(00000810)=0.134548460041203E+02 lr_calc_dens: Charge drift due to real space implementation = -0.86572E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 810 z1= 1 -.336865122770556E-05 0.000000000000000E+00 z1= 2 -.397925973780035E-02 0.000000000000000E+00 z1= 3 -.223258576247126E-04 0.000000000000000E+00 alpha(00000810)=0.000000000000000E+00 beta (00000811)=0.130519217736937E+02 gamma(00000811)=0.130519217736937E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.71507E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 811 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000811)=0.000000000000000E+00 beta (00000812)=0.134503044105502E+02 gamma(00000812)=0.134503044105502E+02 lr_calc_dens: Charge drift due to real space implementation = 0.77107E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 812 z1= 1 0.878588354793260E-05 0.000000000000000E+00 z1= 2 0.347071080200399E-02 0.000000000000000E+00 z1= 3 0.221301951036453E-04 0.000000000000000E+00 alpha(00000812)=0.000000000000000E+00 beta (00000813)=0.130389995910658E+02 gamma(00000813)=0.130389995910658E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.45747E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 813 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000813)=0.000000000000000E+00 beta (00000814)=0.134985676183101E+02 gamma(00000814)=0.134985676183101E+02 lr_calc_dens: Charge drift due to real space implementation = 0.92528E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 814 z1= 1 -.131798500537846E-04 0.000000000000000E+00 z1= 2 -.297963990570617E-02 0.000000000000000E+00 z1= 3 -.218031516425859E-04 0.000000000000000E+00 alpha(00000814)=0.000000000000000E+00 beta (00000815)=0.130228757881490E+02 gamma(00000815)=0.130228757881490E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.82768E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 815 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000815)=0.000000000000000E+00 beta (00000816)=0.134895165816679E+02 gamma(00000816)=0.134895165816679E+02 lr_calc_dens: Charge drift due to real space implementation = -0.29264E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 816 z1= 1 0.153964196248375E-04 0.000000000000000E+00 z1= 2 0.254497534716598E-02 0.000000000000000E+00 z1= 3 0.220843120202394E-04 0.000000000000000E+00 alpha(00000816)=0.000000000000000E+00 beta (00000817)=0.131165435270289E+02 gamma(00000817)=0.131165435270289E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.70883E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 817 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000817)=0.000000000000000E+00 beta (00000818)=0.134506519880557E+02 gamma(00000818)=0.134506519880557E+02 lr_calc_dens: Charge drift due to real space implementation = -0.77906E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 818 z1= 1 -.180846992840714E-04 0.000000000000000E+00 z1= 2 -.208519076449546E-02 0.000000000000000E+00 z1= 3 -.215330316959378E-04 0.000000000000000E+00 alpha(00000818)=0.000000000000000E+00 beta (00000819)=0.130811497529422E+02 gamma(00000819)=0.130811497529422E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.85672E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 819 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000819)=0.000000000000000E+00 beta (00000820)=0.134337428766431E+02 gamma(00000820)=0.134337428766431E+02 lr_calc_dens: Charge drift due to real space implementation = 0.39092E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 820 z1= 1 0.241362919914129E-04 0.000000000000000E+00 z1= 2 0.160008432361738E-02 0.000000000000000E+00 z1= 3 0.203421552591815E-04 0.000000000000000E+00 alpha(00000820)=0.000000000000000E+00 beta (00000821)=0.130546452104454E+02 gamma(00000821)=0.130546452104454E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.91937E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 821 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000821)=0.000000000000000E+00 beta (00000822)=0.135561319525923E+02 gamma(00000822)=0.135561319525923E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10690E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 822 z1= 1 -.286353672494175E-04 0.000000000000000E+00 z1= 2 -.112735230392961E-02 0.000000000000000E+00 z1= 3 -.185472506403024E-04 0.000000000000000E+00 alpha(00000822)=0.000000000000000E+00 beta (00000823)=0.130636177454111E+02 gamma(00000823)=0.130636177454111E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.28190E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 823 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000823)=0.000000000000000E+00 beta (00000824)=0.134584454221336E+02 gamma(00000824)=0.134584454221336E+02 lr_calc_dens: Charge drift due to real space implementation = 0.75859E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 824 z1= 1 0.300386242994850E-04 0.000000000000000E+00 z1= 2 0.638865810306213E-03 0.000000000000000E+00 z1= 3 0.173117503914428E-04 0.000000000000000E+00 alpha(00000824)=0.000000000000000E+00 beta (00000825)=0.130384089888976E+02 gamma(00000825)=0.130384089888976E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.47945E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 825 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000825)=0.000000000000000E+00 beta (00000826)=0.134755011568816E+02 gamma(00000826)=0.134755011568816E+02 lr_calc_dens: Charge drift due to real space implementation = -0.72250E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 826 z1= 1 -.327760889871354E-04 0.000000000000000E+00 z1= 2 -.162590185072564E-03 0.000000000000000E+00 z1= 3 -.160823339752169E-04 0.000000000000000E+00 alpha(00000826)=0.000000000000000E+00 beta (00000827)=0.129122440443721E+02 gamma(00000827)=0.129122440443721E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.30390E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 827 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000827)=0.000000000000000E+00 beta (00000828)=0.134925021142781E+02 gamma(00000828)=0.134925021142781E+02 lr_calc_dens: Charge drift due to real space implementation = -0.49685E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 828 z1= 1 0.347614361258697E-04 0.000000000000000E+00 z1= 2 -.274304665332983E-03 0.000000000000000E+00 z1= 3 0.154430896718986E-04 0.000000000000000E+00 alpha(00000828)=0.000000000000000E+00 beta (00000829)=0.130360310316737E+02 gamma(00000829)=0.130360310316737E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.82634E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 829 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000829)=0.000000000000000E+00 beta (00000830)=0.135733680179868E+02 gamma(00000830)=0.135733680179868E+02 lr_calc_dens: Charge drift due to real space implementation = -0.37492E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 830 z1= 1 -.373152188935773E-04 0.000000000000000E+00 z1= 2 0.751277685881110E-03 0.000000000000000E+00 z1= 3 -.149809378228378E-04 0.000000000000000E+00 alpha(00000830)=0.000000000000000E+00 beta (00000831)=0.129704561218886E+02 gamma(00000831)=0.129704561218886E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.93621E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 831 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000831)=0.000000000000000E+00 beta (00000832)=0.135331257503037E+02 gamma(00000832)=0.135331257503037E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12343E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 832 z1= 1 0.406224566457708E-04 0.000000000000000E+00 z1= 2 -.128006663530688E-02 0.000000000000000E+00 z1= 3 0.142402144696723E-04 0.000000000000000E+00 alpha(00000832)=0.000000000000000E+00 beta (00000833)=0.130362727403398E+02 gamma(00000833)=0.130362727403398E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.73866E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 833 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000833)=0.000000000000000E+00 beta (00000834)=0.135185852618406E+02 gamma(00000834)=0.135185852618406E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11069E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 834 z1= 1 -.444543830039842E-04 0.000000000000000E+00 z1= 2 0.172698952353175E-02 0.000000000000000E+00 z1= 3 -.130596608245394E-04 0.000000000000000E+00 alpha(00000834)=0.000000000000000E+00 beta (00000835)=0.130165052422694E+02 gamma(00000835)=0.130165052422694E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.67775E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 835 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000835)=0.000000000000000E+00 beta (00000836)=0.134990373025732E+02 gamma(00000836)=0.134990373025732E+02 lr_calc_dens: Charge drift due to real space implementation = 0.28542E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 836 z1= 1 0.480612934679964E-04 0.000000000000000E+00 z1= 2 -.206842836096284E-02 0.000000000000000E+00 z1= 3 0.114891448441852E-04 0.000000000000000E+00 alpha(00000836)=0.000000000000000E+00 beta (00000837)=0.129967505484020E+02 gamma(00000837)=0.129967505484020E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.80919E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 837 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000837)=0.000000000000000E+00 beta (00000838)=0.134811537047960E+02 gamma(00000838)=0.134811537047960E+02 lr_calc_dens: Charge drift due to real space implementation = 0.75842E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 838 z1= 1 -.531395440784631E-04 0.000000000000000E+00 z1= 2 0.231936571445443E-02 0.000000000000000E+00 z1= 3 -.895931725480374E-05 0.000000000000000E+00 alpha(00000838)=0.000000000000000E+00 beta (00000839)=0.130165931974581E+02 gamma(00000839)=0.130165931974581E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.21001E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 839 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000839)=0.000000000000000E+00 beta (00000840)=0.134882975267471E+02 gamma(00000840)=0.134882975267471E+02 lr_calc_dens: Charge drift due to real space implementation = -0.43826E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 840 z1= 1 0.564619864950292E-04 0.000000000000000E+00 z1= 2 -.252977660545826E-02 0.000000000000000E+00 z1= 3 0.614771031002793E-05 0.000000000000000E+00 alpha(00000840)=0.000000000000000E+00 beta (00000841)=0.129678258911877E+02 gamma(00000841)=0.129678258911877E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.51329E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 841 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000841)=0.000000000000000E+00 beta (00000842)=0.134632800272363E+02 gamma(00000842)=0.134632800272363E+02 lr_calc_dens: Charge drift due to real space implementation = 0.71415E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 842 z1= 1 -.602503500269904E-04 0.000000000000000E+00 z1= 2 0.275033518249130E-02 0.000000000000000E+00 z1= 3 -.349028110113900E-05 0.000000000000000E+00 alpha(00000842)=0.000000000000000E+00 beta (00000843)=0.129981737219173E+02 gamma(00000843)=0.129981737219173E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.26489E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 843 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000843)=0.000000000000000E+00 beta (00000844)=0.133966769362056E+02 gamma(00000844)=0.133966769362056E+02 lr_calc_dens: Charge drift due to real space implementation = -0.56312E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 844 z1= 1 0.632244635904470E-04 0.000000000000000E+00 z1= 2 -.306753764293599E-02 0.000000000000000E+00 z1= 3 0.998743352957757E-06 0.000000000000000E+00 alpha(00000844)=0.000000000000000E+00 beta (00000845)=0.130659919822805E+02 gamma(00000845)=0.130659919822805E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11408E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 845 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000845)=0.000000000000000E+00 beta (00000846)=0.133930013024443E+02 gamma(00000846)=0.133930013024443E+02 lr_calc_dens: Charge drift due to real space implementation = -0.83812E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 846 z1= 1 -.645465451635332E-04 0.000000000000000E+00 z1= 2 0.352662105293815E-02 0.000000000000000E+00 z1= 3 0.193007525063615E-05 0.000000000000000E+00 alpha(00000846)=0.000000000000000E+00 beta (00000847)=0.130062872725885E+02 gamma(00000847)=0.130062872725885E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.16882E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 847 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000847)=0.000000000000000E+00 beta (00000848)=0.135498021010355E+02 gamma(00000848)=0.135498021010355E+02 lr_calc_dens: Charge drift due to real space implementation = 0.17762E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 848 z1= 1 0.658426753155266E-04 0.000000000000000E+00 z1= 2 -.407066162007903E-02 0.000000000000000E+00 z1= 3 -.467718009838324E-05 0.000000000000000E+00 alpha(00000848)=0.000000000000000E+00 beta (00000849)=0.130116856110329E+02 gamma(00000849)=0.130116856110329E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.17163E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 849 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000849)=0.000000000000000E+00 beta (00000850)=0.134794700946937E+02 gamma(00000850)=0.134794700946937E+02 lr_calc_dens: Charge drift due to real space implementation = -0.17394E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 850 z1= 1 -.655348355609324E-04 0.000000000000000E+00 z1= 2 0.473791651251357E-02 0.000000000000000E+00 z1= 3 0.748466219573647E-05 0.000000000000000E+00 alpha(00000850)=0.000000000000000E+00 beta (00000851)=0.130109774288817E+02 gamma(00000851)=0.130109774288817E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11801E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 851 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000851)=0.000000000000000E+00 beta (00000852)=0.135268804271030E+02 gamma(00000852)=0.135268804271030E+02 lr_calc_dens: Charge drift due to real space implementation = 0.38265E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 852 z1= 1 0.661937742215115E-04 0.000000000000000E+00 z1= 2 -.532151454020583E-02 0.000000000000000E+00 z1= 3 -.931522527634398E-05 0.000000000000000E+00 alpha(00000852)=0.000000000000000E+00 beta (00000853)=0.129967247056244E+02 gamma(00000853)=0.129967247056244E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.90584E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 853 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000853)=0.000000000000000E+00 beta (00000854)=0.135410435303454E+02 gamma(00000854)=0.135410435303454E+02 lr_calc_dens: Charge drift due to real space implementation = 0.15007E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 854 z1= 1 -.672488016183093E-04 0.000000000000000E+00 z1= 2 0.572380524418007E-02 0.000000000000000E+00 z1= 3 0.106920999795898E-04 0.000000000000000E+00 alpha(00000854)=0.000000000000000E+00 beta (00000855)=0.129630973973105E+02 gamma(00000855)=0.129630973973105E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.67430E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 855 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000855)=0.000000000000000E+00 beta (00000856)=0.134709497842218E+02 gamma(00000856)=0.134709497842218E+02 lr_calc_dens: Charge drift due to real space implementation = -0.62185E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 856 z1= 1 0.708660692377511E-04 0.000000000000000E+00 z1= 2 -.598432051051625E-02 0.000000000000000E+00 z1= 3 -.108130561479735E-04 0.000000000000000E+00 alpha(00000856)=0.000000000000000E+00 beta (00000857)=0.129983183236665E+02 gamma(00000857)=0.129983183236665E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.32286E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 857 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000857)=0.000000000000000E+00 beta (00000858)=0.134491394328569E+02 gamma(00000858)=0.134491394328569E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12681E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 858 z1= 1 -.758602460637558E-04 0.000000000000000E+00 z1= 2 0.616060707678548E-02 0.000000000000000E+00 z1= 3 0.102704561629937E-04 0.000000000000000E+00 alpha(00000858)=0.000000000000000E+00 beta (00000859)=0.130926911867776E+02 gamma(00000859)=0.130926911867776E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.93454E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 859 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000859)=0.000000000000000E+00 beta (00000860)=0.133793098620258E+02 gamma(00000860)=0.133793098620258E+02 lr_calc_dens: Charge drift due to real space implementation = -0.80358E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 860 z1= 1 0.802908374256056E-04 0.000000000000000E+00 z1= 2 -.652843306490540E-02 0.000000000000000E+00 z1= 3 -.843527061651504E-05 0.000000000000000E+00 alpha(00000860)=0.000000000000000E+00 beta (00000861)=0.130195792659075E+02 gamma(00000861)=0.130195792659075E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.18595E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 861 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000861)=0.000000000000000E+00 beta (00000862)=0.134358311304329E+02 gamma(00000862)=0.134358311304329E+02 lr_calc_dens: Charge drift due to real space implementation = -0.61041E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 862 z1= 1 -.809922111758305E-04 0.000000000000000E+00 z1= 2 0.694749498942007E-02 0.000000000000000E+00 z1= 3 0.726955519560883E-05 0.000000000000000E+00 alpha(00000862)=0.000000000000000E+00 beta (00000863)=0.129705453942908E+02 gamma(00000863)=0.129705453942908E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14534E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 863 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000863)=0.000000000000000E+00 beta (00000864)=0.135457643876567E+02 gamma(00000864)=0.135457643876567E+02 lr_calc_dens: Charge drift due to real space implementation = 0.15452E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 864 z1= 1 0.816358566311116E-04 0.000000000000000E+00 z1= 2 -.720645927595338E-02 0.000000000000000E+00 z1= 3 -.600292751449608E-05 0.000000000000000E+00 alpha(00000864)=0.000000000000000E+00 beta (00000865)=0.129988999767303E+02 gamma(00000865)=0.129988999767303E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.50474E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 865 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000865)=0.000000000000000E+00 beta (00000866)=0.135634698853804E+02 gamma(00000866)=0.135634698853804E+02 lr_calc_dens: Charge drift due to real space implementation = -0.17776E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 866 z1= 1 -.818479832163932E-04 0.000000000000000E+00 z1= 2 0.726513015209513E-02 0.000000000000000E+00 z1= 3 0.669129737290209E-05 0.000000000000000E+00 alpha(00000866)=0.000000000000000E+00 beta (00000867)=0.129162470259687E+02 gamma(00000867)=0.129162470259687E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.59155E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 867 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000867)=0.000000000000000E+00 beta (00000868)=0.136040831171144E+02 gamma(00000868)=0.136040831171144E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12966E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 868 z1= 1 0.819541938909575E-04 0.000000000000000E+00 z1= 2 -.710396651437478E-02 0.000000000000000E+00 z1= 3 -.752228807737946E-05 0.000000000000000E+00 alpha(00000868)=0.000000000000000E+00 beta (00000869)=0.130480726707342E+02 gamma(00000869)=0.130480726707342E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.15721E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 869 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000869)=0.000000000000000E+00 beta (00000870)=0.135319825241818E+02 gamma(00000870)=0.135319825241818E+02 lr_calc_dens: Charge drift due to real space implementation = 0.16698E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 870 z1= 1 -.831341599115626E-04 0.000000000000000E+00 z1= 2 0.702153174310656E-02 0.000000000000000E+00 z1= 3 0.100029445997122E-04 0.000000000000000E+00 alpha(00000870)=0.000000000000000E+00 beta (00000871)=0.130056284517931E+02 gamma(00000871)=0.130056284517931E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11409E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 871 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000871)=0.000000000000000E+00 beta (00000872)=0.135139623172616E+02 gamma(00000872)=0.135139623172616E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11683E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 872 z1= 1 0.847769598412021E-04 0.000000000000000E+00 z1= 2 -.689500062404132E-02 0.000000000000000E+00 z1= 3 -.113373477960676E-04 0.000000000000000E+00 alpha(00000872)=0.000000000000000E+00 beta (00000873)=0.130433099247398E+02 gamma(00000873)=0.130433099247398E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.36791E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 873 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000873)=0.000000000000000E+00 beta (00000874)=0.135305598743106E+02 gamma(00000874)=0.135305598743106E+02 lr_calc_dens: Charge drift due to real space implementation = 0.39075E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 874 z1= 1 -.872057673522754E-04 0.000000000000000E+00 z1= 2 0.672730039219611E-02 0.000000000000000E+00 z1= 3 0.134694953833697E-04 0.000000000000000E+00 alpha(00000874)=0.000000000000000E+00 beta (00000875)=0.130224557213576E+02 gamma(00000875)=0.130224557213576E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.77061E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 875 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000875)=0.000000000000000E+00 beta (00000876)=0.135067430017868E+02 gamma(00000876)=0.135067430017868E+02 lr_calc_dens: Charge drift due to real space implementation = 0.55201E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 876 z1= 1 0.907964814101485E-04 0.000000000000000E+00 z1= 2 -.658898720591276E-02 0.000000000000000E+00 z1= 3 -.147129434523044E-04 0.000000000000000E+00 alpha(00000876)=0.000000000000000E+00 beta (00000877)=0.130229818259119E+02 gamma(00000877)=0.130229818259119E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.20656E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 877 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000877)=0.000000000000000E+00 beta (00000878)=0.134583352606912E+02 gamma(00000878)=0.134583352606912E+02 lr_calc_dens: Charge drift due to real space implementation = -0.69910E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 878 z1= 1 -.931606121931184E-04 0.000000000000000E+00 z1= 2 0.652195326826623E-02 0.000000000000000E+00 z1= 3 0.165919233219072E-04 0.000000000000000E+00 alpha(00000878)=0.000000000000000E+00 beta (00000879)=0.130500370656874E+02 gamma(00000879)=0.130500370656874E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.36104E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 879 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000879)=0.000000000000000E+00 beta (00000880)=0.134834040052459E+02 gamma(00000880)=0.134834040052459E+02 lr_calc_dens: Charge drift due to real space implementation = 0.25203E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 880 z1= 1 0.923902669498610E-04 0.000000000000000E+00 z1= 2 -.643868248636341E-02 0.000000000000000E+00 z1= 3 -.177240402469329E-04 0.000000000000000E+00 alpha(00000880)=0.000000000000000E+00 beta (00000881)=0.129681323873869E+02 gamma(00000881)=0.129681323873869E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.23883E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 881 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000881)=0.000000000000000E+00 beta (00000882)=0.134286536267603E+02 gamma(00000882)=0.134286536267603E+02 lr_calc_dens: Charge drift due to real space implementation = -0.16269E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 882 z1= 1 -.930388987007841E-04 0.000000000000000E+00 z1= 2 0.625264107146389E-02 0.000000000000000E+00 z1= 3 0.186873953042397E-04 0.000000000000000E+00 alpha(00000882)=0.000000000000000E+00 beta (00000883)=0.130383100226401E+02 gamma(00000883)=0.130383100226401E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.53694E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 883 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000883)=0.000000000000000E+00 beta (00000884)=0.134926629556216E+02 gamma(00000884)=0.134926629556216E+02 lr_calc_dens: Charge drift due to real space implementation = 0.53937E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 884 z1= 1 0.922526034712965E-04 0.000000000000000E+00 z1= 2 -.593483584085284E-02 0.000000000000000E+00 z1= 3 -.196683628250492E-04 0.000000000000000E+00 alpha(00000884)=0.000000000000000E+00 beta (00000885)=0.130699229346058E+02 gamma(00000885)=0.130699229346058E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.68304E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 885 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000885)=0.000000000000000E+00 beta (00000886)=0.135073195927404E+02 gamma(00000886)=0.135073195927404E+02 lr_calc_dens: Charge drift due to real space implementation = -0.13458E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 886 z1= 1 -.920880149930352E-04 0.000000000000000E+00 z1= 2 0.548874895066190E-02 0.000000000000000E+00 z1= 3 0.203582263823728E-04 0.000000000000000E+00 alpha(00000886)=0.000000000000000E+00 beta (00000887)=0.130289399460441E+02 gamma(00000887)=0.130289399460441E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.96362E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 887 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000887)=0.000000000000000E+00 beta (00000888)=0.134707008224696E+02 gamma(00000888)=0.134707008224696E+02 lr_calc_dens: Charge drift due to real space implementation = -0.60646E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 888 z1= 1 0.926199437282314E-04 0.000000000000000E+00 z1= 2 -.501377094629307E-02 0.000000000000000E+00 z1= 3 -.213276669796906E-04 0.000000000000000E+00 alpha(00000888)=0.000000000000000E+00 beta (00000889)=0.130788980605531E+02 gamma(00000889)=0.130788980605531E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.45507E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 889 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000889)=0.000000000000000E+00 beta (00000890)=0.135686150748294E+02 gamma(00000890)=0.135686150748294E+02 lr_calc_dens: Charge drift due to real space implementation = 0.79351E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 890 z1= 1 -.931185192876915E-04 0.000000000000000E+00 z1= 2 0.454094535232768E-02 0.000000000000000E+00 z1= 3 0.219966471657908E-04 0.000000000000000E+00 alpha(00000890)=0.000000000000000E+00 beta (00000891)=0.130532377242991E+02 gamma(00000891)=0.130532377242991E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.20862E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 891 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000891)=0.000000000000000E+00 beta (00000892)=0.133507904913549E+02 gamma(00000892)=0.133507904913549E+02 lr_calc_dens: Charge drift due to real space implementation = -0.38400E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 892 z1= 1 0.926848293174524E-04 0.000000000000000E+00 z1= 2 -.422290259783121E-02 0.000000000000000E+00 z1= 3 -.236221223634789E-04 0.000000000000000E+00 alpha(00000892)=0.000000000000000E+00 beta (00000893)=0.130357413373831E+02 gamma(00000893)=0.130357413373831E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.53474E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 893 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000893)=0.000000000000000E+00 beta (00000894)=0.134443741612613E+02 gamma(00000894)=0.134443741612613E+02 lr_calc_dens: Charge drift due to real space implementation = -0.25450E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 894 z1= 1 -.923511955559083E-04 0.000000000000000E+00 z1= 2 0.406301506174452E-02 0.000000000000000E+00 z1= 3 0.260411764237394E-04 0.000000000000000E+00 alpha(00000894)=0.000000000000000E+00 beta (00000895)=0.131171691461550E+02 gamma(00000895)=0.131171691461550E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.18470E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 895 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000895)=0.000000000000000E+00 beta (00000896)=0.134655395376405E+02 gamma(00000896)=0.134655395376405E+02 lr_calc_dens: Charge drift due to real space implementation = 0.21761E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 896 z1= 1 0.925172735929411E-04 0.000000000000000E+00 z1= 2 -.408894753292118E-02 0.000000000000000E+00 z1= 3 -.298255419582763E-04 0.000000000000000E+00 alpha(00000896)=0.000000000000000E+00 beta (00000897)=0.129810411112133E+02 gamma(00000897)=0.129810411112133E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.42405E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 897 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000897)=0.000000000000000E+00 beta (00000898)=0.134677390556161E+02 gamma(00000898)=0.134677390556161E+02 lr_calc_dens: Charge drift due to real space implementation = 0.75292E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 898 z1= 1 -.951518221449718E-04 0.000000000000000E+00 z1= 2 0.422598707591298E-02 0.000000000000000E+00 z1= 3 0.330524111215541E-04 0.000000000000000E+00 alpha(00000898)=0.000000000000000E+00 beta (00000899)=0.129771837564888E+02 gamma(00000899)=0.129771837564888E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.44102E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 899 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000899)=0.000000000000000E+00 beta (00000900)=0.134450116637402E+02 gamma(00000900)=0.134450116637402E+02 lr_calc_dens: Charge drift due to real space implementation = 0.46916E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 900 z1= 1 0.942302625800279E-04 0.000000000000000E+00 z1= 2 -.448598081264131E-02 0.000000000000000E+00 z1= 3 -.360836382040766E-04 0.000000000000000E+00 alpha(00000900)=0.000000000000000E+00 beta (00000901)=0.130829886353665E+02 gamma(00000901)=0.130829886353665E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.11379E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 901 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000901)=0.000000000000000E+00 beta (00000902)=0.133881442198219E+02 gamma(00000902)=0.133881442198219E+02 lr_calc_dens: Charge drift due to real space implementation = -0.39473E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 902 z1= 1 -.966418209480168E-04 0.000000000000000E+00 z1= 2 0.477046067313842E-02 0.000000000000000E+00 z1= 3 0.390531951135447E-04 0.000000000000000E+00 alpha(00000902)=0.000000000000000E+00 beta (00000903)=0.130280467915456E+02 gamma(00000903)=0.130280467915456E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.57878E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 903 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000903)=0.000000000000000E+00 beta (00000904)=0.135078689303899E+02 gamma(00000904)=0.135078689303899E+02 lr_calc_dens: Charge drift due to real space implementation = -0.52110E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 904 z1= 1 0.944646290305263E-04 0.000000000000000E+00 z1= 2 -.498718803947881E-02 0.000000000000000E+00 z1= 3 -.411482454615924E-04 0.000000000000000E+00 alpha(00000904)=0.000000000000000E+00 beta (00000905)=0.130719250409068E+02 gamma(00000905)=0.130719250409068E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.60295E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 905 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000905)=0.000000000000000E+00 beta (00000906)=0.134952504496692E+02 gamma(00000906)=0.134952504496692E+02 lr_calc_dens: Charge drift due to real space implementation = 0.56028E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 906 z1= 1 -.988919765447151E-04 0.000000000000000E+00 z1= 2 0.519060334091765E-02 0.000000000000000E+00 z1= 3 0.425080682452045E-04 0.000000000000000E+00 alpha(00000906)=0.000000000000000E+00 beta (00000907)=0.130212292375726E+02 gamma(00000907)=0.130212292375726E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.93217E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 907 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000907)=0.000000000000000E+00 beta (00000908)=0.134553098218745E+02 gamma(00000908)=0.134553098218745E+02 lr_calc_dens: Charge drift due to real space implementation = -0.61564E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 908 z1= 1 0.100354118704503E-03 0.000000000000000E+00 z1= 2 -.535179681279656E-02 0.000000000000000E+00 z1= 3 -.434412582457822E-04 0.000000000000000E+00 alpha(00000908)=0.000000000000000E+00 beta (00000909)=0.128616527852063E+02 gamma(00000909)=0.128616527852063E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.41390E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 909 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000909)=0.000000000000000E+00 beta (00000910)=0.135872963250446E+02 gamma(00000910)=0.135872963250446E+02 lr_calc_dens: Charge drift due to real space implementation = 0.25670E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 910 z1= 1 -.997949091504809E-04 0.000000000000000E+00 z1= 2 0.542748386568069E-02 0.000000000000000E+00 z1= 3 0.424234638642464E-04 0.000000000000000E+00 alpha(00000910)=0.000000000000000E+00 beta (00000911)=0.131436571427399E+02 gamma(00000911)=0.131436571427399E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.40224E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 911 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000911)=0.000000000000000E+00 beta (00000912)=0.135502132227091E+02 gamma(00000912)=0.135502132227091E+02 lr_calc_dens: Charge drift due to real space implementation = -0.24912E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 912 z1= 1 0.989040228484249E-04 0.000000000000000E+00 z1= 2 -.561556021703213E-02 0.000000000000000E+00 z1= 3 -.421326533050541E-04 0.000000000000000E+00 alpha(00000912)=0.000000000000000E+00 beta (00000913)=0.130305446671494E+02 gamma(00000913)=0.130305446671494E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.63554E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 913 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000913)=0.000000000000000E+00 beta (00000914)=0.135228761503203E+02 gamma(00000914)=0.135228761503203E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11282E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 914 z1= 1 -.998806739399109E-04 0.000000000000000E+00 z1= 2 0.582522132064836E-02 0.000000000000000E+00 z1= 3 0.417677869126418E-04 0.000000000000000E+00 alpha(00000914)=0.000000000000000E+00 beta (00000915)=0.130347102250719E+02 gamma(00000915)=0.130347102250719E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.68695E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 915 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000915)=0.000000000000000E+00 beta (00000916)=0.134629055365833E+02 gamma(00000916)=0.134629055365833E+02 lr_calc_dens: Charge drift due to real space implementation = 0.28616E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 916 z1= 1 0.988676162248271E-04 0.000000000000000E+00 z1= 2 -.616255674212661E-02 0.000000000000000E+00 z1= 3 -.425169081147785E-04 0.000000000000000E+00 alpha(00000916)=0.000000000000000E+00 beta (00000917)=0.130503999193988E+02 gamma(00000917)=0.130503999193988E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.43387E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 917 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000917)=0.000000000000000E+00 beta (00000918)=0.134389239340178E+02 gamma(00000918)=0.134389239340178E+02 lr_calc_dens: Charge drift due to real space implementation = -0.32635E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 918 z1= 1 -.102168481683549E-03 0.000000000000000E+00 z1= 2 0.655606874113163E-02 0.000000000000000E+00 z1= 3 0.434897556305791E-04 0.000000000000000E+00 alpha(00000918)=0.000000000000000E+00 beta (00000919)=0.131001443329158E+02 gamma(00000919)=0.131001443329158E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.27789E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 919 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000919)=0.000000000000000E+00 beta (00000920)=0.134889403504715E+02 gamma(00000920)=0.134889403504715E+02 lr_calc_dens: Charge drift due to real space implementation = 0.26939E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 920 z1= 1 0.104668688137404E-03 0.000000000000000E+00 z1= 2 -.690493494927382E-02 0.000000000000000E+00 z1= 3 -.443174452941703E-04 0.000000000000000E+00 alpha(00000920)=0.000000000000000E+00 beta (00000921)=0.130766641532453E+02 gamma(00000921)=0.130766641532453E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.38735E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 921 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000921)=0.000000000000000E+00 beta (00000922)=0.134281471351187E+02 gamma(00000922)=0.134281471351187E+02 lr_calc_dens: Charge drift due to real space implementation = -0.61279E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 922 z1= 1 -.108643524509392E-03 0.000000000000000E+00 z1= 2 0.723833065038151E-02 0.000000000000000E+00 z1= 3 0.450922148242680E-04 0.000000000000000E+00 alpha(00000922)=0.000000000000000E+00 beta (00000923)=0.130561875726877E+02 gamma(00000923)=0.130561875726877E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.15811E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 923 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000923)=0.000000000000000E+00 beta (00000924)=0.135250445619808E+02 gamma(00000924)=0.135250445619808E+02 lr_calc_dens: Charge drift due to real space implementation = 0.53211E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 924 z1= 1 0.111178397762939E-03 0.000000000000000E+00 z1= 2 -.748302213785095E-02 0.000000000000000E+00 z1= 3 -.454385532602627E-04 0.000000000000000E+00 alpha(00000924)=0.000000000000000E+00 beta (00000925)=0.131189919059765E+02 gamma(00000925)=0.131189919059765E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.20087E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 925 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000925)=0.000000000000000E+00 beta (00000926)=0.134696359011091E+02 gamma(00000926)=0.134696359011091E+02 lr_calc_dens: Charge drift due to real space implementation = -0.36145E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 926 z1= 1 -.115268747663609E-03 0.000000000000000E+00 z1= 2 0.765561146650517E-02 0.000000000000000E+00 z1= 3 0.463224997844535E-04 0.000000000000000E+00 alpha(00000926)=0.000000000000000E+00 beta (00000927)=0.130086306996665E+02 gamma(00000927)=0.130086306996665E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.33284E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 927 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000927)=0.000000000000000E+00 beta (00000928)=0.134904097750835E+02 gamma(00000928)=0.134904097750835E+02 lr_calc_dens: Charge drift due to real space implementation = 0.31720E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 928 z1= 1 0.115815802965773E-03 0.000000000000000E+00 z1= 2 -.761550230559603E-02 0.000000000000000E+00 z1= 3 -.461435936434275E-04 0.000000000000000E+00 alpha(00000928)=0.000000000000000E+00 beta (00000929)=0.131228863086052E+02 gamma(00000929)=0.131228863086052E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.91583E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 929 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000929)=0.000000000000000E+00 beta (00000930)=0.134626947028691E+02 gamma(00000930)=0.134626947028691E+02 lr_calc_dens: Charge drift due to real space implementation = 0.77614E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 930 z1= 1 -.118743038177684E-03 0.000000000000000E+00 z1= 2 0.753117689032012E-02 0.000000000000000E+00 z1= 3 0.478001101832046E-04 0.000000000000000E+00 alpha(00000930)=0.000000000000000E+00 beta (00000931)=0.130457928778316E+02 gamma(00000931)=0.130457928778316E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.23758E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 931 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000931)=0.000000000000000E+00 beta (00000932)=0.134663754784260E+02 gamma(00000932)=0.134663754784260E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12050E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 932 z1= 1 0.119986740845426E-03 0.000000000000000E+00 z1= 2 -.726517662771772E-02 0.000000000000000E+00 z1= 3 -.491451064037820E-04 0.000000000000000E+00 alpha(00000932)=0.000000000000000E+00 beta (00000933)=0.130483386262547E+02 gamma(00000933)=0.130483386262547E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.87980E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 933 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000933)=0.000000000000000E+00 beta (00000934)=0.134792113872807E+02 gamma(00000934)=0.134792113872807E+02 lr_calc_dens: Charge drift due to real space implementation = 0.50247E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 934 z1= 1 -.123122208693316E-03 0.000000000000000E+00 z1= 2 0.692552138269345E-02 0.000000000000000E+00 z1= 3 0.510893480632879E-04 0.000000000000000E+00 alpha(00000934)=0.000000000000000E+00 beta (00000935)=0.130127209761331E+02 gamma(00000935)=0.130127209761331E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12275E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 935 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000935)=0.000000000000000E+00 beta (00000936)=0.135600063258785E+02 gamma(00000936)=0.135600063258785E+02 lr_calc_dens: Charge drift due to real space implementation = 0.28614E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 936 z1= 1 0.126250935230251E-03 0.000000000000000E+00 z1= 2 -.664253838220964E-02 0.000000000000000E+00 z1= 3 -.525914888600969E-04 0.000000000000000E+00 alpha(00000936)=0.000000000000000E+00 beta (00000937)=0.130422174554935E+02 gamma(00000937)=0.130422174554935E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.99136E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 937 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000937)=0.000000000000000E+00 beta (00000938)=0.135305684201267E+02 gamma(00000938)=0.135305684201267E+02 lr_calc_dens: Charge drift due to real space implementation = -0.66180E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 938 z1= 1 -.126499860737880E-03 0.000000000000000E+00 z1= 2 0.671016298023796E-02 0.000000000000000E+00 z1= 3 0.549929834115574E-04 0.000000000000000E+00 alpha(00000938)=0.000000000000000E+00 beta (00000939)=0.130252114348655E+02 gamma(00000939)=0.130252114348655E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.71667E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 939 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000939)=0.000000000000000E+00 beta (00000940)=0.134121117513833E+02 gamma(00000940)=0.134121117513833E+02 lr_calc_dens: Charge drift due to real space implementation = 0.74039E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 940 z1= 1 0.128254415622055E-03 0.000000000000000E+00 z1= 2 -.698741492942315E-02 0.000000000000000E+00 z1= 3 -.577031843570336E-04 0.000000000000000E+00 alpha(00000940)=0.000000000000000E+00 beta (00000941)=0.130340980295760E+02 gamma(00000941)=0.130340980295760E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.80859E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 941 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000941)=0.000000000000000E+00 beta (00000942)=0.134617104220219E+02 gamma(00000942)=0.134617104220219E+02 lr_calc_dens: Charge drift due to real space implementation = -0.14215E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 942 z1= 1 -.132688989201128E-03 0.000000000000000E+00 z1= 2 0.718192474410173E-02 0.000000000000000E+00 z1= 3 0.594986696036001E-04 0.000000000000000E+00 alpha(00000942)=0.000000000000000E+00 beta (00000943)=0.130305225737315E+02 gamma(00000943)=0.130305225737315E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.80504E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 943 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000943)=0.000000000000000E+00 beta (00000944)=0.133958220535219E+02 gamma(00000944)=0.133958220535219E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12406E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 944 z1= 1 0.135926199105045E-03 0.000000000000000E+00 z1= 2 -.719711330520799E-02 0.000000000000000E+00 z1= 3 -.619922041459047E-04 0.000000000000000E+00 alpha(00000944)=0.000000000000000E+00 beta (00000945)=0.131126735574636E+02 gamma(00000945)=0.131126735574636E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.83780E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 945 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000945)=0.000000000000000E+00 beta (00000946)=0.134652957979008E+02 gamma(00000946)=0.134652957979008E+02 lr_calc_dens: Charge drift due to real space implementation = -0.52078E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 946 z1= 1 -.138107660279240E-03 0.000000000000000E+00 z1= 2 0.693044244542843E-02 0.000000000000000E+00 z1= 3 0.640235036398494E-04 0.000000000000000E+00 alpha(00000946)=0.000000000000000E+00 beta (00000947)=0.130675016108715E+02 gamma(00000947)=0.130675016108715E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11645E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 947 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000947)=0.000000000000000E+00 beta (00000948)=0.133758374328321E+02 gamma(00000948)=0.133758374328321E+02 lr_calc_dens: Charge drift due to real space implementation = -0.43456E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 948 z1= 1 0.144923213052440E-03 0.000000000000000E+00 z1= 2 -.642393174868930E-02 0.000000000000000E+00 z1= 3 -.664928969923670E-04 0.000000000000000E+00 alpha(00000948)=0.000000000000000E+00 beta (00000949)=0.130681907030703E+02 gamma(00000949)=0.130681907030703E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.91850E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 949 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000949)=0.000000000000000E+00 beta (00000950)=0.133740991360501E+02 gamma(00000950)=0.133740991360501E+02 lr_calc_dens: Charge drift due to real space implementation = 0.14229E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 950 z1= 1 -.149121165017584E-03 0.000000000000000E+00 z1= 2 0.581449910784853E-02 0.000000000000000E+00 z1= 3 0.684245766740177E-04 0.000000000000000E+00 alpha(00000950)=0.000000000000000E+00 beta (00000951)=0.130296484931540E+02 gamma(00000951)=0.130296484931540E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.53969E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 951 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000951)=0.000000000000000E+00 beta (00000952)=0.134556396660581E+02 gamma(00000952)=0.134556396660581E+02 lr_calc_dens: Charge drift due to real space implementation = -0.82275E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 952 z1= 1 0.150717649836596E-03 0.000000000000000E+00 z1= 2 -.513129933239141E-02 0.000000000000000E+00 z1= 3 -.696944510131351E-04 0.000000000000000E+00 alpha(00000952)=0.000000000000000E+00 beta (00000953)=0.131162159383657E+02 gamma(00000953)=0.131162159383657E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.14076E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 953 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000953)=0.000000000000000E+00 beta (00000954)=0.134629790596405E+02 gamma(00000954)=0.134629790596405E+02 lr_calc_dens: Charge drift due to real space implementation = -0.50955E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 954 z1= 1 -.153576613551186E-03 0.000000000000000E+00 z1= 2 0.456111339996726E-02 0.000000000000000E+00 z1= 3 0.715989376756895E-04 0.000000000000000E+00 alpha(00000954)=0.000000000000000E+00 beta (00000955)=0.130930804490355E+02 gamma(00000955)=0.130930804490355E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10819E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 955 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000955)=0.000000000000000E+00 beta (00000956)=0.134231750550500E+02 gamma(00000956)=0.134231750550500E+02 lr_calc_dens: Charge drift due to real space implementation = 0.14564E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 956 z1= 1 0.156675875470575E-03 0.000000000000000E+00 z1= 2 -.419357668006780E-02 0.000000000000000E+00 z1= 3 -.739905387922449E-04 0.000000000000000E+00 alpha(00000956)=0.000000000000000E+00 beta (00000957)=0.130739211717645E+02 gamma(00000957)=0.130739211717645E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.35618E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 957 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000957)=0.000000000000000E+00 beta (00000958)=0.133893688561351E+02 gamma(00000958)=0.133893688561351E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12983E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 958 z1= 1 -.158535384517540E-03 0.000000000000000E+00 z1= 2 0.396314686740867E-02 0.000000000000000E+00 z1= 3 0.764571326213480E-04 0.000000000000000E+00 alpha(00000958)=0.000000000000000E+00 beta (00000959)=0.129960260519103E+02 gamma(00000959)=0.129960260519103E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.85240E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 959 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000959)=0.000000000000000E+00 beta (00000960)=0.134844200077596E+02 gamma(00000960)=0.134844200077596E+02 lr_calc_dens: Charge drift due to real space implementation = 0.51556E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 960 z1= 1 0.159618293447359E-03 0.000000000000000E+00 z1= 2 -.372789304508265E-02 0.000000000000000E+00 z1= 3 -.789080672692416E-04 0.000000000000000E+00 alpha(00000960)=0.000000000000000E+00 beta (00000961)=0.129670652448139E+02 gamma(00000961)=0.129670652448139E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.83809E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 961 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000961)=0.000000000000000E+00 beta (00000962)=0.135480218579939E+02 gamma(00000962)=0.135480218579939E+02 lr_calc_dens: Charge drift due to real space implementation = -0.18008E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 962 z1= 1 -.158030651158800E-03 0.000000000000000E+00 z1= 2 0.349200710852584E-02 0.000000000000000E+00 z1= 3 0.811095907220371E-04 0.000000000000000E+00 alpha(00000962)=0.000000000000000E+00 beta (00000963)=0.130031563002176E+02 gamma(00000963)=0.130031563002176E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.94992E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 963 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000963)=0.000000000000000E+00 beta (00000964)=0.135377352754652E+02 gamma(00000964)=0.135377352754652E+02 lr_calc_dens: Charge drift due to real space implementation = -0.55239E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 964 z1= 1 0.155882892077243E-03 0.000000000000000E+00 z1= 2 -.323472833187185E-02 0.000000000000000E+00 z1= 3 -.841855212944336E-04 0.000000000000000E+00 alpha(00000964)=0.000000000000000E+00 beta (00000965)=0.130071600433721E+02 gamma(00000965)=0.130071600433721E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.24400E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 965 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000965)=0.000000000000000E+00 beta (00000966)=0.134398830134256E+02 gamma(00000966)=0.134398830134256E+02 lr_calc_dens: Charge drift due to real space implementation = 0.47344E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 966 z1= 1 -.155824342880639E-03 0.000000000000000E+00 z1= 2 0.298977996165907E-02 0.000000000000000E+00 z1= 3 0.867363653831594E-04 0.000000000000000E+00 alpha(00000966)=0.000000000000000E+00 beta (00000967)=0.129870392195047E+02 gamma(00000967)=0.129870392195047E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.17597E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 967 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000967)=0.000000000000000E+00 beta (00000968)=0.134100740243293E+02 gamma(00000968)=0.134100740243293E+02 lr_calc_dens: Charge drift due to real space implementation = -0.90343E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 968 z1= 1 0.155222131243040E-03 0.000000000000000E+00 z1= 2 -.271373580120189E-02 0.000000000000000E+00 z1= 3 -.895680123101199E-04 0.000000000000000E+00 alpha(00000968)=0.000000000000000E+00 beta (00000969)=0.129086351452684E+02 gamma(00000969)=0.129086351452684E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.11220E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 969 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000969)=0.000000000000000E+00 beta (00000970)=0.135103227624062E+02 gamma(00000970)=0.135103227624062E+02 lr_calc_dens: Charge drift due to real space implementation = 0.63431E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 970 z1= 1 -.157121150491515E-03 0.000000000000000E+00 z1= 2 0.238720091777305E-02 0.000000000000000E+00 z1= 3 0.899828634525788E-04 0.000000000000000E+00 alpha(00000970)=0.000000000000000E+00 beta (00000971)=0.130566037441077E+02 gamma(00000971)=0.130566037441077E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.63250E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 971 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000971)=0.000000000000000E+00 beta (00000972)=0.134389187824792E+02 gamma(00000972)=0.134389187824792E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11007E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 972 z1= 1 0.160322902673555E-03 0.000000000000000E+00 z1= 2 -.206081589753470E-02 0.000000000000000E+00 z1= 3 -.926169024404723E-04 0.000000000000000E+00 alpha(00000972)=0.000000000000000E+00 beta (00000973)=0.130981058005167E+02 gamma(00000973)=0.130981058005167E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.85160E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 973 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000973)=0.000000000000000E+00 beta (00000974)=0.134750049412927E+02 gamma(00000974)=0.134750049412927E+02 lr_calc_dens: Charge drift due to real space implementation = -0.84672E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 974 z1= 1 -.160989144416991E-03 0.000000000000000E+00 z1= 2 0.179592767615695E-02 0.000000000000000E+00 z1= 3 0.947903132291669E-04 0.000000000000000E+00 alpha(00000974)=0.000000000000000E+00 beta (00000975)=0.131234317052375E+02 gamma(00000975)=0.131234317052375E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.15892E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 975 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000975)=0.000000000000000E+00 beta (00000976)=0.134689529850392E+02 gamma(00000976)=0.134689529850392E+02 lr_calc_dens: Charge drift due to real space implementation = 0.41201E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 976 z1= 1 0.158809868844398E-03 0.000000000000000E+00 z1= 2 -.182589706512468E-02 0.000000000000000E+00 z1= 3 -.985303872461511E-04 0.000000000000000E+00 alpha(00000976)=0.000000000000000E+00 beta (00000977)=0.130776005214759E+02 gamma(00000977)=0.130776005214759E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.37049E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 977 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000977)=0.000000000000000E+00 beta (00000978)=0.134702123088398E+02 gamma(00000978)=0.134702123088398E+02 lr_calc_dens: Charge drift due to real space implementation = 0.17693E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 978 z1= 1 -.163274394451035E-03 0.000000000000000E+00 z1= 2 0.215114209654989E-02 0.000000000000000E+00 z1= 3 0.101266905161369E-03 0.000000000000000E+00 alpha(00000978)=0.000000000000000E+00 beta (00000979)=0.130132741151921E+02 gamma(00000979)=0.130132741151921E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.32114E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 979 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000979)=0.000000000000000E+00 beta (00000980)=0.134669380226499E+02 gamma(00000980)=0.134669380226499E+02 lr_calc_dens: Charge drift due to real space implementation = 0.28767E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 980 z1= 1 0.165323872726072E-03 0.000000000000000E+00 z1= 2 -.263081409563732E-02 0.000000000000000E+00 z1= 3 -.103761906782235E-03 0.000000000000000E+00 alpha(00000980)=0.000000000000000E+00 beta (00000981)=0.130730075034023E+02 gamma(00000981)=0.130730075034023E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.23929E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 981 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000981)=0.000000000000000E+00 beta (00000982)=0.134782685382015E+02 gamma(00000982)=0.134782685382015E+02 lr_calc_dens: Charge drift due to real space implementation = -0.45872E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 982 z1= 1 -.166646652885843E-03 0.000000000000000E+00 z1= 2 0.302610120705807E-02 0.000000000000000E+00 z1= 3 0.105156901341804E-03 0.000000000000000E+00 alpha(00000982)=0.000000000000000E+00 beta (00000983)=0.130973754554004E+02 gamma(00000983)=0.130973754554004E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.80244E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 983 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000983)=0.000000000000000E+00 beta (00000984)=0.134939646357127E+02 gamma(00000984)=0.134939646357127E+02 lr_calc_dens: Charge drift due to real space implementation = 0.78471E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 984 z1= 1 0.166073253248421E-03 0.000000000000000E+00 z1= 2 -.316104902360078E-02 0.000000000000000E+00 z1= 3 -.108377772906562E-03 0.000000000000000E+00 alpha(00000984)=0.000000000000000E+00 beta (00000985)=0.131054519443307E+02 gamma(00000985)=0.131054519443307E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.26007E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 985 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000985)=0.000000000000000E+00 beta (00000986)=0.134330038713512E+02 gamma(00000986)=0.134330038713512E+02 lr_calc_dens: Charge drift due to real space implementation = -0.33140E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 986 z1= 1 -.165720785546804E-03 0.000000000000000E+00 z1= 2 0.301442356546916E-02 0.000000000000000E+00 z1= 3 0.111068856112962E-03 0.000000000000000E+00 alpha(00000986)=0.000000000000000E+00 beta (00000987)=0.132278911872007E+02 gamma(00000987)=0.132278911872007E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.19341E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 987 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000987)=0.000000000000000E+00 beta (00000988)=0.135217074486172E+02 gamma(00000988)=0.135217074486172E+02 lr_calc_dens: Charge drift due to real space implementation = 0.68081E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 988 z1= 1 0.165677229533988E-03 0.000000000000000E+00 z1= 2 -.273984900755426E-02 0.000000000000000E+00 z1= 3 -.114585124936798E-03 0.000000000000000E+00 alpha(00000988)=0.000000000000000E+00 beta (00000989)=0.130901935352946E+02 gamma(00000989)=0.130901935352946E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.37088E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 989 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000989)=0.000000000000000E+00 beta (00000990)=0.134279442654096E+02 gamma(00000990)=0.134279442654096E+02 lr_calc_dens: Charge drift due to real space implementation = -0.62214E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 990 z1= 1 -.168164366880262E-03 0.000000000000000E+00 z1= 2 0.252787975772838E-02 0.000000000000000E+00 z1= 3 0.115400793046822E-03 0.000000000000000E+00 alpha(00000990)=0.000000000000000E+00 beta (00000991)=0.130416345939663E+02 gamma(00000991)=0.130416345939663E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11305E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 991 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000991)=0.000000000000000E+00 beta (00000992)=0.134309225083038E+02 gamma(00000992)=0.134309225083038E+02 lr_calc_dens: Charge drift due to real space implementation = -0.34197E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 992 z1= 1 0.165088275930279E-03 0.000000000000000E+00 z1= 2 -.243607470827247E-02 0.000000000000000E+00 z1= 3 -.116094543855595E-03 0.000000000000000E+00 alpha(00000992)=0.000000000000000E+00 beta (00000993)=0.131394726185593E+02 gamma(00000993)=0.131394726185593E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.74397E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 993 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000993)=0.000000000000000E+00 beta (00000994)=0.134235270585488E+02 gamma(00000994)=0.134235270585488E+02 lr_calc_dens: Charge drift due to real space implementation = 0.83023E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 994 z1= 1 -.164254379049041E-03 0.000000000000000E+00 z1= 2 0.244444898151749E-02 0.000000000000000E+00 z1= 3 0.116463402781609E-03 0.000000000000000E+00 alpha(00000994)=0.000000000000000E+00 beta (00000995)=0.131019519838015E+02 gamma(00000995)=0.131019519838015E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.45159E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 995 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000995)=0.000000000000000E+00 beta (00000996)=0.134051801887197E+02 gamma(00000996)=0.134051801887197E+02 lr_calc_dens: Charge drift due to real space implementation = 0.31488E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 996 z1= 1 0.166968569679274E-03 0.000000000000000E+00 z1= 2 -.238330598236669E-02 0.000000000000000E+00 z1= 3 -.117266161125634E-03 0.000000000000000E+00 alpha(00000996)=0.000000000000000E+00 beta (00000997)=0.130782816062060E+02 gamma(00000997)=0.130782816062060E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12849E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 997 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000997)=0.000000000000000E+00 beta (00000998)=0.133700076084032E+02 gamma(00000998)=0.133700076084032E+02 lr_calc_dens: Charge drift due to real space implementation = -0.79615E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 998 z1= 1 -.168151402209306E-03 0.000000000000000E+00 z1= 2 0.213844215244170E-02 0.000000000000000E+00 z1= 3 0.117306948094702E-03 0.000000000000000E+00 alpha(00000998)=0.000000000000000E+00 beta (00000999)=0.131496958760018E+02 gamma(00000999)=0.131496958760018E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.64288E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 999 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000999)=0.000000000000000E+00 beta (00001000)=0.134662566411883E+02 gamma(00001000)=0.134662566411883E+02 lr_calc_dens: Charge drift due to real space implementation = 0.30315E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1000 z1= 1 0.167064040995892E-03 0.000000000000000E+00 z1= 2 -.174501171265034E-02 0.000000000000000E+00 z1= 3 -.118705489415411E-03 0.000000000000000E+00 alpha(00001000)=0.000000000000000E+00 beta (00001001)=0.131205925247846E+02 gamma(00001001)=0.131205925247846E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.84739E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1001 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001001)=0.000000000000000E+00 beta (00001002)=0.134666305126935E+02 gamma(00001002)=0.134666305126935E+02 lr_calc_dens: Charge drift due to real space implementation = 0.40077E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1002 z1= 1 -.165123672156478E-03 0.000000000000000E+00 z1= 2 0.128724982877222E-02 0.000000000000000E+00 z1= 3 0.118539943761716E-03 0.000000000000000E+00 alpha(00001002)=0.000000000000000E+00 beta (00001003)=0.130845648562650E+02 gamma(00001003)=0.130845648562650E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.37771E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1003 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001003)=0.000000000000000E+00 beta (00001004)=0.133889573661236E+02 gamma(00001004)=0.133889573661236E+02 lr_calc_dens: Charge drift due to real space implementation = -0.62872E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1004 z1= 1 0.164653599305604E-03 0.000000000000000E+00 z1= 2 -.833107325572423E-03 0.000000000000000E+00 z1= 3 -.120216767937452E-03 0.000000000000000E+00 alpha(00001004)=0.000000000000000E+00 beta (00001005)=0.130408263296534E+02 gamma(00001005)=0.130408263296534E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.22543E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1005 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001005)=0.000000000000000E+00 beta (00001006)=0.134065425842393E+02 gamma(00001006)=0.134065425842393E+02 lr_calc_dens: Charge drift due to real space implementation = 0.22123E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1006 z1= 1 -.162268630031997E-03 0.000000000000000E+00 z1= 2 0.427137202079463E-03 0.000000000000000E+00 z1= 3 0.119883250989287E-03 0.000000000000000E+00 alpha(00001006)=0.000000000000000E+00 beta (00001007)=0.130465026888305E+02 gamma(00001007)=0.130465026888305E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.36374E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1007 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001007)=0.000000000000000E+00 beta (00001008)=0.133699436459418E+02 gamma(00001008)=0.133699436459418E+02 lr_calc_dens: Charge drift due to real space implementation = 0.30025E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1008 z1= 1 0.163552826368873E-03 0.000000000000000E+00 z1= 2 -.108710739586467E-03 0.000000000000000E+00 z1= 3 -.121187103694024E-03 0.000000000000000E+00 alpha(00001008)=0.000000000000000E+00 beta (00001009)=0.131083442030021E+02 gamma(00001009)=0.131083442030021E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.23328E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1009 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001009)=0.000000000000000E+00 beta (00001010)=0.134042817698283E+02 gamma(00001010)=0.134042817698283E+02 lr_calc_dens: Charge drift due to real space implementation = -0.84299E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1010 z1= 1 -.161377475047703E-03 0.000000000000000E+00 z1= 2 -.110496878162542E-03 0.000000000000000E+00 z1= 3 0.121054716258047E-03 0.000000000000000E+00 alpha(00001010)=0.000000000000000E+00 beta (00001011)=0.131438016872320E+02 gamma(00001011)=0.131438016872320E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.43530E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1011 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001011)=0.000000000000000E+00 beta (00001012)=0.134355550955962E+02 gamma(00001012)=0.134355550955962E+02 lr_calc_dens: Charge drift due to real space implementation = 0.82438E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1012 z1= 1 0.160919527572913E-03 0.000000000000000E+00 z1= 2 0.269890734363952E-03 0.000000000000000E+00 z1= 3 -.122335402407317E-03 0.000000000000000E+00 alpha(00001012)=0.000000000000000E+00 beta (00001013)=0.130293457766209E+02 gamma(00001013)=0.130293457766209E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.11131E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1013 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001013)=0.000000000000000E+00 beta (00001014)=0.133484170007732E+02 gamma(00001014)=0.133484170007732E+02 lr_calc_dens: Charge drift due to real space implementation = -0.42244E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1014 z1= 1 -.161038935657786E-03 0.000000000000000E+00 z1= 2 -.515340699278722E-03 0.000000000000000E+00 z1= 3 0.123138723854701E-03 0.000000000000000E+00 alpha(00001014)=0.000000000000000E+00 beta (00001015)=0.131373553561506E+02 gamma(00001015)=0.131373553561506E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.16908E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1015 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001015)=0.000000000000000E+00 beta (00001016)=0.133861420451131E+02 gamma(00001016)=0.133861420451131E+02 lr_calc_dens: Charge drift due to real space implementation = -0.58074E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1016 z1= 1 0.163112014895009E-03 0.000000000000000E+00 z1= 2 0.906197727517766E-03 0.000000000000000E+00 z1= 3 -.124938693104723E-03 0.000000000000000E+00 alpha(00001016)=0.000000000000000E+00 beta (00001017)=0.131469678123408E+02 gamma(00001017)=0.131469678123408E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12750E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1017 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001017)=0.000000000000000E+00 beta (00001018)=0.133561023445601E+02 gamma(00001018)=0.133561023445601E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10991E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1018 z1= 1 -.161949867012887E-03 0.000000000000000E+00 z1= 2 -.140360786059912E-02 0.000000000000000E+00 z1= 3 0.126477322932674E-03 0.000000000000000E+00 alpha(00001018)=0.000000000000000E+00 beta (00001019)=0.131304675341976E+02 gamma(00001019)=0.131304675341976E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.34031E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1019 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001019)=0.000000000000000E+00 beta (00001020)=0.133978993570578E+02 gamma(00001020)=0.133978993570578E+02 lr_calc_dens: Charge drift due to real space implementation = -0.65961E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1020 z1= 1 0.162408391616013E-03 0.000000000000000E+00 z1= 2 0.187459571376264E-02 0.000000000000000E+00 z1= 3 -.128155578572779E-03 0.000000000000000E+00 alpha(00001020)=0.000000000000000E+00 beta (00001021)=0.131580360581106E+02 gamma(00001021)=0.131580360581106E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.17631E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1021 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001021)=0.000000000000000E+00 beta (00001022)=0.134429167410203E+02 gamma(00001022)=0.134429167410203E+02 lr_calc_dens: Charge drift due to real space implementation = 0.65953E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1022 z1= 1 -.162416669129160E-03 0.000000000000000E+00 z1= 2 -.220847369764797E-02 0.000000000000000E+00 z1= 3 0.128949260973894E-03 0.000000000000000E+00 alpha(00001022)=0.000000000000000E+00 beta (00001023)=0.131673385124603E+02 gamma(00001023)=0.131673385124603E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.25208E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1023 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001023)=0.000000000000000E+00 beta (00001024)=0.133113599446435E+02 gamma(00001024)=0.133113599446435E+02 lr_calc_dens: Charge drift due to real space implementation = -0.38518E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1024 z1= 1 0.165428674817333E-03 0.000000000000000E+00 z1= 2 0.243095284109750E-02 0.000000000000000E+00 z1= 3 -.131536008269478E-03 0.000000000000000E+00 alpha(00001024)=0.000000000000000E+00 beta (00001025)=0.130563780356463E+02 gamma(00001025)=0.130563780356463E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.48445E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1025 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001025)=0.000000000000000E+00 beta (00001026)=0.133539913182324E+02 gamma(00001026)=0.133539913182324E+02 lr_calc_dens: Charge drift due to real space implementation = 0.53180E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1026 z1= 1 -.163437579032465E-03 0.000000000000000E+00 z1= 2 -.257511309312619E-02 0.000000000000000E+00 z1= 3 0.131488983354503E-03 0.000000000000000E+00 alpha(00001026)=0.000000000000000E+00 beta (00001027)=0.131115069277269E+02 gamma(00001027)=0.131115069277269E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.47560E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1027 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001027)=0.000000000000000E+00 beta (00001028)=0.134419704018353E+02 gamma(00001028)=0.134419704018353E+02 lr_calc_dens: Charge drift due to real space implementation = 0.27919E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1028 z1= 1 0.161673671214217E-03 0.000000000000000E+00 z1= 2 0.271640717184730E-02 0.000000000000000E+00 z1= 3 -.130368397463366E-03 0.000000000000000E+00 alpha(00001028)=0.000000000000000E+00 beta (00001029)=0.131392605512787E+02 gamma(00001029)=0.131392605512787E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.14902E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1029 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001029)=0.000000000000000E+00 beta (00001030)=0.133610075707732E+02 gamma(00001030)=0.133610075707732E+02 lr_calc_dens: Charge drift due to real space implementation = -0.34419E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1030 z1= 1 -.160668052853035E-03 0.000000000000000E+00 z1= 2 -.281659575469991E-02 0.000000000000000E+00 z1= 3 0.130088321407950E-03 0.000000000000000E+00 alpha(00001030)=0.000000000000000E+00 beta (00001031)=0.130412972736033E+02 gamma(00001031)=0.130412972736033E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.63976E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1031 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001031)=0.000000000000000E+00 beta (00001032)=0.133857715375122E+02 gamma(00001032)=0.133857715375122E+02 lr_calc_dens: Charge drift due to real space implementation = 0.55345E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1032 z1= 1 0.160557322523531E-03 0.000000000000000E+00 z1= 2 0.285392739973604E-02 0.000000000000000E+00 z1= 3 -.127207808884147E-03 0.000000000000000E+00 alpha(00001032)=0.000000000000000E+00 beta (00001033)=0.131710418775164E+02 gamma(00001033)=0.131710418775164E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.60559E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1033 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001033)=0.000000000000000E+00 beta (00001034)=0.134224839699606E+02 gamma(00001034)=0.134224839699606E+02 lr_calc_dens: Charge drift due to real space implementation = -0.36070E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1034 z1= 1 -.161082198877246E-03 0.000000000000000E+00 z1= 2 -.287869114686552E-02 0.000000000000000E+00 z1= 3 0.126629512073854E-03 0.000000000000000E+00 alpha(00001034)=0.000000000000000E+00 beta (00001035)=0.132329918088938E+02 gamma(00001035)=0.132329918088938E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10833E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1035 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001035)=0.000000000000000E+00 beta (00001036)=0.133739849582111E+02 gamma(00001036)=0.133739849582111E+02 lr_calc_dens: Charge drift due to real space implementation = -0.34773E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1036 z1= 1 0.161200726828521E-03 0.000000000000000E+00 z1= 2 0.300831554273733E-02 0.000000000000000E+00 z1= 3 -.126721580863827E-03 0.000000000000000E+00 alpha(00001036)=0.000000000000000E+00 beta (00001037)=0.130887666480107E+02 gamma(00001037)=0.130887666480107E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.79156E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1037 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001037)=0.000000000000000E+00 beta (00001038)=0.133586019461014E+02 gamma(00001038)=0.133586019461014E+02 lr_calc_dens: Charge drift due to real space implementation = 0.59629E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1038 z1= 1 -.159496570099583E-03 0.000000000000000E+00 z1= 2 -.323830268042572E-02 0.000000000000000E+00 z1= 3 0.126829290997770E-03 0.000000000000000E+00 alpha(00001038)=0.000000000000000E+00 beta (00001039)=0.131734783518165E+02 gamma(00001039)=0.131734783518165E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.23413E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1039 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001039)=0.000000000000000E+00 beta (00001040)=0.133974091135145E+02 gamma(00001040)=0.133974091135145E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12399E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1040 z1= 1 0.158510645519802E-03 0.000000000000000E+00 z1= 2 0.349586328884070E-02 0.000000000000000E+00 z1= 3 -.126691676073746E-03 0.000000000000000E+00 alpha(00001040)=0.000000000000000E+00 beta (00001041)=0.131315817344198E+02 gamma(00001041)=0.131315817344198E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.29431E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1041 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001041)=0.000000000000000E+00 beta (00001042)=0.133858214030709E+02 gamma(00001042)=0.133858214030709E+02 lr_calc_dens: Charge drift due to real space implementation = -0.23176E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1042 z1= 1 -.157978579821709E-03 0.000000000000000E+00 z1= 2 -.369362773559473E-02 0.000000000000000E+00 z1= 3 0.128520632140598E-03 0.000000000000000E+00 alpha(00001042)=0.000000000000000E+00 beta (00001043)=0.131677264356141E+02 gamma(00001043)=0.131677264356141E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.92686E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1043 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001043)=0.000000000000000E+00 beta (00001044)=0.133418349182976E+02 gamma(00001044)=0.133418349182976E+02 lr_calc_dens: Charge drift due to real space implementation = -0.42858E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1044 z1= 1 0.158663493586810E-03 0.000000000000000E+00 z1= 2 0.381331675647458E-02 0.000000000000000E+00 z1= 3 -.130575058444872E-03 0.000000000000000E+00 alpha(00001044)=0.000000000000000E+00 beta (00001045)=0.132265460575092E+02 gamma(00001045)=0.132265460575092E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.58155E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1045 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001045)=0.000000000000000E+00 beta (00001046)=0.132914256231695E+02 gamma(00001046)=0.132914256231695E+02 lr_calc_dens: Charge drift due to real space implementation = 0.57376E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1046 z1= 1 -.160852267502280E-03 0.000000000000000E+00 z1= 2 -.388044151839863E-02 0.000000000000000E+00 z1= 3 0.134468141452657E-03 0.000000000000000E+00 alpha(00001046)=0.000000000000000E+00 beta (00001047)=0.131033917000776E+02 gamma(00001047)=0.131033917000776E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.19295E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1047 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001047)=0.000000000000000E+00 beta (00001048)=0.134296475576004E+02 gamma(00001048)=0.134296475576004E+02 lr_calc_dens: Charge drift due to real space implementation = -0.31149E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1048 z1= 1 0.156157197022191E-03 0.000000000000000E+00 z1= 2 0.378746032554599E-02 0.000000000000000E+00 z1= 3 -.134260186587194E-03 0.000000000000000E+00 alpha(00001048)=0.000000000000000E+00 beta (00001049)=0.130624510279393E+02 gamma(00001049)=0.130624510279393E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.26187E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1049 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001049)=0.000000000000000E+00 beta (00001050)=0.132981208239053E+02 gamma(00001050)=0.132981208239053E+02 lr_calc_dens: Charge drift due to real space implementation = 0.52525E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1050 z1= 1 -.150319022141120E-03 0.000000000000000E+00 z1= 2 -.365639648904370E-02 0.000000000000000E+00 z1= 3 0.136371228808298E-03 0.000000000000000E+00 alpha(00001050)=0.000000000000000E+00 beta (00001051)=0.131761574546378E+02 gamma(00001051)=0.131761574546378E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12299E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1051 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001051)=0.000000000000000E+00 beta (00001052)=0.133479206086622E+02 gamma(00001052)=0.133479206086622E+02 lr_calc_dens: Charge drift due to real space implementation = -0.44181E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1052 z1= 1 0.144834188094871E-03 0.000000000000000E+00 z1= 2 0.347187139475206E-02 0.000000000000000E+00 z1= 3 -.137674233460321E-03 0.000000000000000E+00 alpha(00001052)=0.000000000000000E+00 beta (00001053)=0.131785735958277E+02 gamma(00001053)=0.131785735958277E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.43654E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1053 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001053)=0.000000000000000E+00 beta (00001054)=0.133281996510699E+02 gamma(00001054)=0.133281996510699E+02 lr_calc_dens: Charge drift due to real space implementation = 0.34720E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1054 z1= 1 -.146009836346621E-03 0.000000000000000E+00 z1= 2 -.333035819100996E-02 0.000000000000000E+00 z1= 3 0.139438429736290E-03 0.000000000000000E+00 alpha(00001054)=0.000000000000000E+00 beta (00001055)=0.131840197396431E+02 gamma(00001055)=0.131840197396431E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.26218E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1055 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001055)=0.000000000000000E+00 beta (00001056)=0.132537735457892E+02 gamma(00001056)=0.132537735457892E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11925E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1056 z1= 1 0.146763173703430E-03 0.000000000000000E+00 z1= 2 0.326409221007078E-02 0.000000000000000E+00 z1= 3 -.139730962291945E-03 0.000000000000000E+00 alpha(00001056)=0.000000000000000E+00 beta (00001057)=0.131299312130223E+02 gamma(00001057)=0.131299312130223E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.69256E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1057 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001057)=0.000000000000000E+00 beta (00001058)=0.133360950401669E+02 gamma(00001058)=0.133360950401669E+02 lr_calc_dens: Charge drift due to real space implementation = -0.87570E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1058 z1= 1 -.146733082099434E-03 0.000000000000000E+00 z1= 2 -.318070848913079E-02 0.000000000000000E+00 z1= 3 0.139112930077123E-03 0.000000000000000E+00 alpha(00001058)=0.000000000000000E+00 beta (00001059)=0.131703768763088E+02 gamma(00001059)=0.131703768763088E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.39987E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1059 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001059)=0.000000000000000E+00 beta (00001060)=0.132920820933417E+02 gamma(00001060)=0.132920820933417E+02 lr_calc_dens: Charge drift due to real space implementation = -0.35235E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1060 z1= 1 0.143394701324708E-03 0.000000000000000E+00 z1= 2 0.315362064004652E-02 0.000000000000000E+00 z1= 3 -.137193191238494E-03 0.000000000000000E+00 alpha(00001060)=0.000000000000000E+00 beta (00001061)=0.131025028819051E+02 gamma(00001061)=0.131025028819051E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.37576E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1061 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001061)=0.000000000000000E+00 beta (00001062)=0.132990159744151E+02 gamma(00001062)=0.132990159744151E+02 lr_calc_dens: Charge drift due to real space implementation = 0.72910E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1062 z1= 1 -.143102944591790E-03 0.000000000000000E+00 z1= 2 -.311526068491823E-02 0.000000000000000E+00 z1= 3 0.135721194843474E-03 0.000000000000000E+00 alpha(00001062)=0.000000000000000E+00 beta (00001063)=0.132109846061260E+02 gamma(00001063)=0.132109846061260E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.38413E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1063 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001063)=0.000000000000000E+00 beta (00001064)=0.133397330351129E+02 gamma(00001064)=0.133397330351129E+02 lr_calc_dens: Charge drift due to real space implementation = -0.13317E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1064 z1= 1 0.136619758188696E-03 0.000000000000000E+00 z1= 2 0.300070000389068E-02 0.000000000000000E+00 z1= 3 -.132064188382098E-03 0.000000000000000E+00 alpha(00001064)=0.000000000000000E+00 beta (00001065)=0.131642535908922E+02 gamma(00001065)=0.131642535908922E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.44256E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1065 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001065)=0.000000000000000E+00 beta (00001066)=0.133464385375675E+02 gamma(00001066)=0.133464385375675E+02 lr_calc_dens: Charge drift due to real space implementation = -0.89662E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1066 z1= 1 -.137582371964402E-03 0.000000000000000E+00 z1= 2 -.280771605326768E-02 0.000000000000000E+00 z1= 3 0.130221826977057E-03 0.000000000000000E+00 alpha(00001066)=0.000000000000000E+00 beta (00001067)=0.131948255463835E+02 gamma(00001067)=0.131948255463835E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.33444E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1067 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001067)=0.000000000000000E+00 beta (00001068)=0.133708633499106E+02 gamma(00001068)=0.133708633499106E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11284E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1068 z1= 1 0.133076881823978E-03 0.000000000000000E+00 z1= 2 0.269307951728359E-02 0.000000000000000E+00 z1= 3 -.126775633034147E-03 0.000000000000000E+00 alpha(00001068)=0.000000000000000E+00 beta (00001069)=0.132191081525421E+02 gamma(00001069)=0.132191081525421E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13433E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1069 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001069)=0.000000000000000E+00 beta (00001070)=0.133052979445390E+02 gamma(00001070)=0.133052979445390E+02 lr_calc_dens: Charge drift due to real space implementation = -0.62181E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1070 z1= 1 -.133460094027292E-03 0.000000000000000E+00 z1= 2 -.270514648137930E-02 0.000000000000000E+00 z1= 3 0.126734802786113E-03 0.000000000000000E+00 alpha(00001070)=0.000000000000000E+00 beta (00001071)=0.131929788200302E+02 gamma(00001071)=0.131929788200302E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.23285E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1071 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001071)=0.000000000000000E+00 beta (00001072)=0.133649602219595E+02 gamma(00001072)=0.133649602219595E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11643E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1072 z1= 1 0.126690007892990E-03 0.000000000000000E+00 z1= 2 0.272368975485708E-02 0.000000000000000E+00 z1= 3 -.123416985374152E-03 0.000000000000000E+00 alpha(00001072)=0.000000000000000E+00 beta (00001073)=0.131953061912455E+02 gamma(00001073)=0.131953061912455E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.16399E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1073 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001073)=0.000000000000000E+00 beta (00001074)=0.133516473798025E+02 gamma(00001074)=0.133516473798025E+02 lr_calc_dens: Charge drift due to real space implementation = 0.26918E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1074 z1= 1 -.122892688210677E-03 0.000000000000000E+00 z1= 2 -.270921757676999E-02 0.000000000000000E+00 z1= 3 0.123259273210633E-03 0.000000000000000E+00 alpha(00001074)=0.000000000000000E+00 beta (00001075)=0.131041019844699E+02 gamma(00001075)=0.131041019844699E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.76483E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1075 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001075)=0.000000000000000E+00 beta (00001076)=0.133905422730122E+02 gamma(00001076)=0.133905422730122E+02 lr_calc_dens: Charge drift due to real space implementation = -0.18396E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1076 z1= 1 0.115459920939106E-03 0.000000000000000E+00 z1= 2 0.266278393849994E-02 0.000000000000000E+00 z1= 3 -.119661789327024E-03 0.000000000000000E+00 alpha(00001076)=0.000000000000000E+00 beta (00001077)=0.130763258173779E+02 gamma(00001077)=0.130763258173779E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.22160E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1077 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001077)=0.000000000000000E+00 beta (00001078)=0.133772382801687E+02 gamma(00001078)=0.133772382801687E+02 lr_calc_dens: Charge drift due to real space implementation = -0.38263E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1078 z1= 1 -.111761993004203E-03 0.000000000000000E+00 z1= 2 -.268817322916818E-02 0.000000000000000E+00 z1= 3 0.117762196421093E-03 0.000000000000000E+00 alpha(00001078)=0.000000000000000E+00 beta (00001079)=0.131382589282389E+02 gamma(00001079)=0.131382589282389E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12695E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1079 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001079)=0.000000000000000E+00 beta (00001080)=0.134109309365012E+02 gamma(00001080)=0.134109309365012E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12014E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1080 z1= 1 0.104972282999726E-03 0.000000000000000E+00 z1= 2 0.287841401015684E-02 0.000000000000000E+00 z1= 3 -.113024643415446E-03 0.000000000000000E+00 alpha(00001080)=0.000000000000000E+00 beta (00001081)=0.131081008764532E+02 gamma(00001081)=0.131081008764532E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.37427E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1081 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001081)=0.000000000000000E+00 beta (00001082)=0.134146259485036E+02 gamma(00001082)=0.134146259485036E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10530E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1082 z1= 1 -.999680616362263E-04 0.000000000000000E+00 z1= 2 -.323834637904157E-02 0.000000000000000E+00 z1= 3 0.110580946178638E-03 0.000000000000000E+00 alpha(00001082)=0.000000000000000E+00 beta (00001083)=0.131172389763145E+02 gamma(00001083)=0.131172389763145E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.79983E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1083 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001083)=0.000000000000000E+00 beta (00001084)=0.134629265732214E+02 gamma(00001084)=0.134629265732214E+02 lr_calc_dens: Charge drift due to real space implementation = 0.52584E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1084 z1= 1 0.905374149498504E-04 0.000000000000000E+00 z1= 2 0.367792858644320E-02 0.000000000000000E+00 z1= 3 -.104507408630839E-03 0.000000000000000E+00 alpha(00001084)=0.000000000000000E+00 beta (00001085)=0.131296822094734E+02 gamma(00001085)=0.131296822094734E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14046E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1085 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001085)=0.000000000000000E+00 beta (00001086)=0.133534702547925E+02 gamma(00001086)=0.133534702547925E+02 lr_calc_dens: Charge drift due to real space implementation = 0.63281E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1086 z1= 1 -.856254663136116E-04 0.000000000000000E+00 z1= 2 -.415564327088521E-02 0.000000000000000E+00 z1= 3 0.102637785931322E-03 0.000000000000000E+00 alpha(00001086)=0.000000000000000E+00 beta (00001087)=0.130626190176678E+02 gamma(00001087)=0.130626190176678E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.88778E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1087 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001087)=0.000000000000000E+00 beta (00001088)=0.134834391012704E+02 gamma(00001088)=0.134834391012704E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10465E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1088 z1= 1 0.818738024525034E-04 0.000000000000000E+00 z1= 2 0.446474135644009E-02 0.000000000000000E+00 z1= 3 -.962072916332902E-04 0.000000000000000E+00 alpha(00001088)=0.000000000000000E+00 beta (00001089)=0.131098890125088E+02 gamma(00001089)=0.131098890125088E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.16108E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1089 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001089)=0.000000000000000E+00 beta (00001090)=0.132969266696440E+02 gamma(00001090)=0.132969266696440E+02 lr_calc_dens: Charge drift due to real space implementation = 0.72734E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1090 z1= 1 -.771652293228876E-04 0.000000000000000E+00 z1= 2 -.470851886731208E-02 0.000000000000000E+00 z1= 3 0.949465250540444E-04 0.000000000000000E+00 alpha(00001090)=0.000000000000000E+00 beta (00001091)=0.130319065888401E+02 gamma(00001091)=0.130319065888401E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.38246E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1091 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001091)=0.000000000000000E+00 beta (00001092)=0.134783797639212E+02 gamma(00001092)=0.134783797639212E+02 lr_calc_dens: Charge drift due to real space implementation = -0.55248E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1092 z1= 1 0.707079354540525E-04 0.000000000000000E+00 z1= 2 0.480243879689950E-02 0.000000000000000E+00 z1= 3 -.881390819015282E-04 0.000000000000000E+00 alpha(00001092)=0.000000000000000E+00 beta (00001093)=0.130631011313832E+02 gamma(00001093)=0.130631011313832E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.23608E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1093 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001093)=0.000000000000000E+00 beta (00001094)=0.135682848070173E+02 gamma(00001094)=0.135682848070173E+02 lr_calc_dens: Charge drift due to real space implementation = 0.36192E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1094 z1= 1 -.665041338041052E-04 0.000000000000000E+00 z1= 2 -.484689151385064E-02 0.000000000000000E+00 z1= 3 0.846851493571216E-04 0.000000000000000E+00 alpha(00001094)=0.000000000000000E+00 beta (00001095)=0.130704238816599E+02 gamma(00001095)=0.130704238816599E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.48673E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1095 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001095)=0.000000000000000E+00 beta (00001096)=0.134407670654996E+02 gamma(00001096)=0.134407670654996E+02 lr_calc_dens: Charge drift due to real space implementation = 0.63959E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1096 z1= 1 0.631779107306482E-04 0.000000000000000E+00 z1= 2 0.496684320258519E-02 0.000000000000000E+00 z1= 3 -.780603720622024E-04 0.000000000000000E+00 alpha(00001096)=0.000000000000000E+00 beta (00001097)=0.130905964945184E+02 gamma(00001097)=0.130905964945184E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.24120E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1097 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001097)=0.000000000000000E+00 beta (00001098)=0.134569255680652E+02 gamma(00001098)=0.134569255680652E+02 lr_calc_dens: Charge drift due to real space implementation = -0.19628E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1098 z1= 1 -.564112015225739E-04 0.000000000000000E+00 z1= 2 -.513076888383282E-02 0.000000000000000E+00 z1= 3 0.747259016051909E-04 0.000000000000000E+00 alpha(00001098)=0.000000000000000E+00 beta (00001099)=0.130480755697002E+02 gamma(00001099)=0.130480755697002E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.20368E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1099 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001099)=0.000000000000000E+00 beta (00001100)=0.134783482659736E+02 gamma(00001100)=0.134783482659736E+02 lr_calc_dens: Charge drift due to real space implementation = 0.70023E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1100 z1= 1 0.522955480628823E-04 0.000000000000000E+00 z1= 2 0.518102475185441E-02 0.000000000000000E+00 z1= 3 -.682068881234940E-04 0.000000000000000E+00 alpha(00001100)=0.000000000000000E+00 beta (00001101)=0.131130678111660E+02 gamma(00001101)=0.131130678111660E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.81109E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1101 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001101)=0.000000000000000E+00 beta (00001102)=0.134694570364738E+02 gamma(00001102)=0.134694570364738E+02 lr_calc_dens: Charge drift due to real space implementation = -0.16007E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1102 z1= 1 -.477372924891969E-04 0.000000000000000E+00 z1= 2 -.514653765310497E-02 0.000000000000000E+00 z1= 3 0.653082679573537E-04 0.000000000000000E+00 alpha(00001102)=0.000000000000000E+00 beta (00001103)=0.130649579628977E+02 gamma(00001103)=0.130649579628977E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.34668E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1103 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001103)=0.000000000000000E+00 beta (00001104)=0.134256267358132E+02 gamma(00001104)=0.134256267358132E+02 lr_calc_dens: Charge drift due to real space implementation = -0.18211E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1104 z1= 1 0.428639624299801E-04 0.000000000000000E+00 z1= 2 0.493812647471419E-02 0.000000000000000E+00 z1= 3 -.595501437639633E-04 0.000000000000000E+00 alpha(00001104)=0.000000000000000E+00 beta (00001105)=0.130650552091891E+02 gamma(00001105)=0.130650552091891E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.42032E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1105 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001105)=0.000000000000000E+00 beta (00001106)=0.134772502797402E+02 gamma(00001106)=0.134772502797402E+02 lr_calc_dens: Charge drift due to real space implementation = 0.40587E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1106 z1= 1 -.372219424172107E-04 0.000000000000000E+00 z1= 2 -.452026422149670E-02 0.000000000000000E+00 z1= 3 0.547745543594385E-04 0.000000000000000E+00 alpha(00001106)=0.000000000000000E+00 beta (00001107)=0.129489989882291E+02 gamma(00001107)=0.129489989882291E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.52468E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1107 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001107)=0.000000000000000E+00 beta (00001108)=0.134411360491966E+02 gamma(00001108)=0.134411360491966E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10742E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1108 z1= 1 0.319368887382772E-04 0.000000000000000E+00 z1= 2 0.406435963783879E-02 0.000000000000000E+00 z1= 3 -.470666877283310E-04 0.000000000000000E+00 alpha(00001108)=0.000000000000000E+00 beta (00001109)=0.129413715063552E+02 gamma(00001109)=0.129413715063552E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.49094E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1109 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001109)=0.000000000000000E+00 beta (00001110)=0.135124484644896E+02 gamma(00001110)=0.135124484644896E+02 lr_calc_dens: Charge drift due to real space implementation = 0.46294E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1110 z1= 1 -.271996519403146E-04 0.000000000000000E+00 z1= 2 -.360187277551699E-02 0.000000000000000E+00 z1= 3 0.408810726270525E-04 0.000000000000000E+00 alpha(00001110)=0.000000000000000E+00 beta (00001111)=0.129950135518929E+02 gamma(00001111)=0.129950135518929E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.82159E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1111 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001111)=0.000000000000000E+00 beta (00001112)=0.134349649572045E+02 gamma(00001112)=0.134349649572045E+02 lr_calc_dens: Charge drift due to real space implementation = 0.41895E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1112 z1= 1 0.237660187635998E-04 0.000000000000000E+00 z1= 2 0.318342233078329E-02 0.000000000000000E+00 z1= 3 -.330706288995629E-04 0.000000000000000E+00 alpha(00001112)=0.000000000000000E+00 beta (00001113)=0.131031408578132E+02 gamma(00001113)=0.131031408578132E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.17763E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1113 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001113)=0.000000000000000E+00 beta (00001114)=0.134731175302146E+02 gamma(00001114)=0.134731175302146E+02 lr_calc_dens: Charge drift due to real space implementation = -0.19467E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1114 z1= 1 -.196520720097994E-04 0.000000000000000E+00 z1= 2 -.284332041661762E-02 0.000000000000000E+00 z1= 3 0.266472345800749E-04 0.000000000000000E+00 alpha(00001114)=0.000000000000000E+00 beta (00001115)=0.128962599861817E+02 gamma(00001115)=0.128962599861817E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.46877E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1115 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001115)=0.000000000000000E+00 beta (00001116)=0.134946988448907E+02 gamma(00001116)=0.134946988448907E+02 lr_calc_dens: Charge drift due to real space implementation = 0.69822E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1116 z1= 1 0.129310956326588E-04 0.000000000000000E+00 z1= 2 0.248180330333467E-02 0.000000000000000E+00 z1= 3 -.182287402105892E-04 0.000000000000000E+00 alpha(00001116)=0.000000000000000E+00 beta (00001117)=0.129494760440399E+02 gamma(00001117)=0.129494760440399E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.31972E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1117 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001117)=0.000000000000000E+00 beta (00001118)=0.134931857740652E+02 gamma(00001118)=0.134931857740652E+02 lr_calc_dens: Charge drift due to real space implementation = -0.95191E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1118 z1= 1 -.929683263435274E-05 0.000000000000000E+00 z1= 2 -.213995974775518E-02 0.000000000000000E+00 z1= 3 0.116605734384497E-04 0.000000000000000E+00 alpha(00001118)=0.000000000000000E+00 beta (00001119)=0.129991486500404E+02 gamma(00001119)=0.129991486500404E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11438E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1119 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001119)=0.000000000000000E+00 beta (00001120)=0.134137893951279E+02 gamma(00001120)=0.134137893951279E+02 lr_calc_dens: Charge drift due to real space implementation = 0.23817E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1120 z1= 1 0.761380162707381E-05 0.000000000000000E+00 z1= 2 0.180486895540320E-02 0.000000000000000E+00 z1= 3 -.332416485133059E-05 0.000000000000000E+00 alpha(00001120)=0.000000000000000E+00 beta (00001121)=0.130821933247735E+02 gamma(00001121)=0.130821933247735E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.17458E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1121 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001121)=0.000000000000000E+00 beta (00001122)=0.135251548998638E+02 gamma(00001122)=0.135251548998638E+02 lr_calc_dens: Charge drift due to real space implementation = 0.15703E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1122 z1= 1 -.304602659333911E-05 0.000000000000000E+00 z1= 2 -.140195032443153E-02 0.000000000000000E+00 z1= 3 -.332590755299491E-05 0.000000000000000E+00 alpha(00001122)=0.000000000000000E+00 beta (00001123)=0.129202046147433E+02 gamma(00001123)=0.129202046147433E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.83415E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1123 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001123)=0.000000000000000E+00 beta (00001124)=0.136001758760723E+02 gamma(00001124)=0.136001758760723E+02 lr_calc_dens: Charge drift due to real space implementation = -0.22623E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1124 z1= 1 -.219665855750312E-05 0.000000000000000E+00 z1= 2 0.101575398484335E-02 0.000000000000000E+00 z1= 3 0.106497215103693E-04 0.000000000000000E+00 alpha(00001124)=0.000000000000000E+00 beta (00001125)=0.129763601661303E+02 gamma(00001125)=0.129763601661303E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.98059E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1125 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001125)=0.000000000000000E+00 beta (00001126)=0.136517938921315E+02 gamma(00001126)=0.136517938921315E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10830E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1126 z1= 1 0.557435995036156E-05 0.000000000000000E+00 z1= 2 -.640097374684044E-03 0.000000000000000E+00 z1= 3 -.161943264594045E-04 0.000000000000000E+00 alpha(00001126)=0.000000000000000E+00 beta (00001127)=0.129049332827268E+02 gamma(00001127)=0.129049332827268E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.15924E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1127 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001127)=0.000000000000000E+00 beta (00001128)=0.135843100990366E+02 gamma(00001128)=0.135843100990366E+02 lr_calc_dens: Charge drift due to real space implementation = 0.36933E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1128 z1= 1 -.969210735192634E-05 0.000000000000000E+00 z1= 2 0.306100182418534E-03 0.000000000000000E+00 z1= 3 0.220526559138730E-04 0.000000000000000E+00 alpha(00001128)=0.000000000000000E+00 beta (00001129)=0.130092408576031E+02 gamma(00001129)=0.130092408576031E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.93542E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1129 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001129)=0.000000000000000E+00 beta (00001130)=0.135885024245507E+02 gamma(00001130)=0.135885024245507E+02 lr_calc_dens: Charge drift due to real space implementation = -0.80274E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1130 z1= 1 0.106605660882934E-04 0.000000000000000E+00 z1= 2 -.284074554285207E-04 0.000000000000000E+00 z1= 3 -.262451355991031E-04 0.000000000000000E+00 alpha(00001130)=0.000000000000000E+00 beta (00001131)=0.129667449673676E+02 gamma(00001131)=0.129667449673676E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.32080E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1131 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001131)=0.000000000000000E+00 beta (00001132)=0.135375598989059E+02 gamma(00001132)=0.135375598989059E+02 lr_calc_dens: Charge drift due to real space implementation = 0.60839E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1132 z1= 1 -.112774389694368E-04 0.000000000000000E+00 z1= 2 -.207703250252745E-03 0.000000000000000E+00 z1= 3 0.317553228338267E-04 0.000000000000000E+00 alpha(00001132)=0.000000000000000E+00 beta (00001133)=0.129997966911463E+02 gamma(00001133)=0.129997966911463E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.29589E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1133 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001133)=0.000000000000000E+00 beta (00001134)=0.136538736677100E+02 gamma(00001134)=0.136538736677100E+02 lr_calc_dens: Charge drift due to real space implementation = -0.86393E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1134 z1= 1 0.147354029669342E-04 0.000000000000000E+00 z1= 2 0.271043056162124E-03 0.000000000000000E+00 z1= 3 -.350126993628854E-04 0.000000000000000E+00 alpha(00001134)=0.000000000000000E+00 beta (00001135)=0.130120345790676E+02 gamma(00001135)=0.130120345790676E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.26122E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1135 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001135)=0.000000000000000E+00 beta (00001136)=0.134723371879901E+02 gamma(00001136)=0.134723371879901E+02 lr_calc_dens: Charge drift due to real space implementation = 0.61409E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1136 z1= 1 -.210021168841447E-04 0.000000000000000E+00 z1= 2 -.238750693020916E-03 0.000000000000000E+00 z1= 3 0.405050903842179E-04 0.000000000000000E+00 alpha(00001136)=0.000000000000000E+00 beta (00001137)=0.130264799558742E+02 gamma(00001137)=0.130264799558742E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.72706E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1137 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001137)=0.000000000000000E+00 beta (00001138)=0.135529720409618E+02 gamma(00001138)=0.135529720409618E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10790E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1138 z1= 1 0.262148078693913E-04 0.000000000000000E+00 z1= 2 0.144106048596834E-03 0.000000000000000E+00 z1= 3 -.439063243045208E-04 0.000000000000000E+00 alpha(00001138)=0.000000000000000E+00 beta (00001139)=0.129512081017738E+02 gamma(00001139)=0.129512081017738E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.45778E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1139 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001139)=0.000000000000000E+00 beta (00001140)=0.135774861281849E+02 gamma(00001140)=0.135774861281849E+02 lr_calc_dens: Charge drift due to real space implementation = -0.20657E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1140 z1= 1 -.269307161175980E-04 0.000000000000000E+00 z1= 2 -.693722696137392E-04 0.000000000000000E+00 z1= 3 0.493979039113101E-04 0.000000000000000E+00 alpha(00001140)=0.000000000000000E+00 beta (00001141)=0.129076547844118E+02 gamma(00001141)=0.129076547844118E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.60739E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1141 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001141)=0.000000000000000E+00 beta (00001142)=0.135920143747495E+02 gamma(00001142)=0.135920143747495E+02 lr_calc_dens: Charge drift due to real space implementation = 0.66896E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1142 z1= 1 0.288791539643845E-04 0.000000000000000E+00 z1= 2 0.143209459236805E-03 0.000000000000000E+00 z1= 3 -.513651457879505E-04 0.000000000000000E+00 alpha(00001142)=0.000000000000000E+00 beta (00001143)=0.128518482632777E+02 gamma(00001143)=0.128518482632777E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.37069E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1143 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001143)=0.000000000000000E+00 beta (00001144)=0.135622050862386E+02 gamma(00001144)=0.135622050862386E+02 lr_calc_dens: Charge drift due to real space implementation = -0.96184E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1144 z1= 1 -.313184383203564E-04 0.000000000000000E+00 z1= 2 -.340510099345647E-03 0.000000000000000E+00 z1= 3 0.543206195898587E-04 0.000000000000000E+00 alpha(00001144)=0.000000000000000E+00 beta (00001145)=0.128478705922474E+02 gamma(00001145)=0.128478705922474E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.98714E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1145 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001145)=0.000000000000000E+00 beta (00001146)=0.136145649111831E+02 gamma(00001146)=0.136145649111831E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10236E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1146 z1= 1 0.370795394978654E-04 0.000000000000000E+00 z1= 2 0.606013487576006E-03 0.000000000000000E+00 z1= 3 -.558825635605926E-04 0.000000000000000E+00 alpha(00001146)=0.000000000000000E+00 beta (00001147)=0.128630711909401E+02 gamma(00001147)=0.128630711909401E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.95521E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1147 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001147)=0.000000000000000E+00 beta (00001148)=0.134995484096547E+02 gamma(00001148)=0.134995484096547E+02 lr_calc_dens: Charge drift due to real space implementation = -0.17497E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1148 z1= 1 -.439397413298766E-04 0.000000000000000E+00 z1= 2 -.970020360512197E-03 0.000000000000000E+00 z1= 3 0.614423432374644E-04 0.000000000000000E+00 alpha(00001148)=0.000000000000000E+00 beta (00001149)=0.129544150609833E+02 gamma(00001149)=0.129544150609833E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11551E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1149 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001149)=0.000000000000000E+00 beta (00001150)=0.135284148880528E+02 gamma(00001150)=0.135284148880528E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10634E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1150 z1= 1 0.541763636636638E-04 0.000000000000000E+00 z1= 2 0.129073354460719E-02 0.000000000000000E+00 z1= 3 -.656329768153155E-04 0.000000000000000E+00 alpha(00001150)=0.000000000000000E+00 beta (00001151)=0.129599522570180E+02 gamma(00001151)=0.129599522570180E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10359E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1151 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001151)=0.000000000000000E+00 beta (00001152)=0.135370525765672E+02 gamma(00001152)=0.135370525765672E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11812E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1152 z1= 1 -.586738127579152E-04 0.000000000000000E+00 z1= 2 -.163897249411756E-02 0.000000000000000E+00 z1= 3 0.723675079823058E-04 0.000000000000000E+00 alpha(00001152)=0.000000000000000E+00 beta (00001153)=0.129934483508660E+02 gamma(00001153)=0.129934483508660E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.91023E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1153 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001153)=0.000000000000000E+00 beta (00001154)=0.135855790275386E+02 gamma(00001154)=0.135855790275386E+02 lr_calc_dens: Charge drift due to real space implementation = -0.35132E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1154 z1= 1 0.672351288266227E-04 0.000000000000000E+00 z1= 2 0.209110401500589E-02 0.000000000000000E+00 z1= 3 -.763757912464488E-04 0.000000000000000E+00 alpha(00001154)=0.000000000000000E+00 beta (00001155)=0.129135594254943E+02 gamma(00001155)=0.129135594254943E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11910E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1155 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001155)=0.000000000000000E+00 beta (00001156)=0.135731919070725E+02 gamma(00001156)=0.135731919070725E+02 lr_calc_dens: Charge drift due to real space implementation = -0.88231E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1156 z1= 1 -.722962766418036E-04 0.000000000000000E+00 z1= 2 -.263235013391720E-02 0.000000000000000E+00 z1= 3 0.834912076104808E-04 0.000000000000000E+00 alpha(00001156)=0.000000000000000E+00 beta (00001157)=0.130002580373035E+02 gamma(00001157)=0.130002580373035E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.18890E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1157 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001157)=0.000000000000000E+00 beta (00001158)=0.135971880030415E+02 gamma(00001158)=0.135971880030415E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10201E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1158 z1= 1 0.798942137495862E-04 0.000000000000000E+00 z1= 2 0.334298795385066E-02 0.000000000000000E+00 z1= 3 -.879247245600844E-04 0.000000000000000E+00 alpha(00001158)=0.000000000000000E+00 beta (00001159)=0.129360138261253E+02 gamma(00001159)=0.129360138261253E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.73314E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1159 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001159)=0.000000000000000E+00 beta (00001160)=0.135965072177773E+02 gamma(00001160)=0.135965072177773E+02 lr_calc_dens: Charge drift due to real space implementation = -0.51540E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1160 z1= 1 -.873161893240101E-04 0.000000000000000E+00 z1= 2 -.414855742635095E-02 0.000000000000000E+00 z1= 3 0.955080662376203E-04 0.000000000000000E+00 alpha(00001160)=0.000000000000000E+00 beta (00001161)=0.130134603246862E+02 gamma(00001161)=0.130134603246862E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11892E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1161 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001161)=0.000000000000000E+00 beta (00001162)=0.136215158990789E+02 gamma(00001162)=0.136215158990789E+02 lr_calc_dens: Charge drift due to real space implementation = -0.29626E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1162 z1= 1 0.989876625782024E-04 0.000000000000000E+00 z1= 2 0.490749128146177E-02 0.000000000000000E+00 z1= 3 -.100999191541478E-03 0.000000000000000E+00 alpha(00001162)=0.000000000000000E+00 beta (00001163)=0.129715830136063E+02 gamma(00001163)=0.129715830136063E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.99917E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1163 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001163)=0.000000000000000E+00 beta (00001164)=0.136764272499515E+02 gamma(00001164)=0.136764272499515E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10525E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1164 z1= 1 -.105533492534671E-03 0.000000000000000E+00 z1= 2 -.541392322701402E-02 0.000000000000000E+00 z1= 3 0.108757203976513E-03 0.000000000000000E+00 alpha(00001164)=0.000000000000000E+00 beta (00001165)=0.129802835905396E+02 gamma(00001165)=0.129802835905396E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.16556E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1165 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001165)=0.000000000000000E+00 beta (00001166)=0.136026765619509E+02 gamma(00001166)=0.136026765619509E+02 lr_calc_dens: Charge drift due to real space implementation = -0.81773E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1166 z1= 1 0.117693579125152E-03 0.000000000000000E+00 z1= 2 0.580247323965886E-02 0.000000000000000E+00 z1= 3 -.114556130188725E-03 0.000000000000000E+00 alpha(00001166)=0.000000000000000E+00 beta (00001167)=0.129263650705932E+02 gamma(00001167)=0.129263650705932E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.65215E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1167 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001167)=0.000000000000000E+00 beta (00001168)=0.136237189837203E+02 gamma(00001168)=0.136237189837203E+02 lr_calc_dens: Charge drift due to real space implementation = 0.28253E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1168 z1= 1 -.123034247656199E-03 0.000000000000000E+00 z1= 2 -.603546575485252E-02 0.000000000000000E+00 z1= 3 0.120734119287463E-03 0.000000000000000E+00 alpha(00001168)=0.000000000000000E+00 beta (00001169)=0.130134809381623E+02 gamma(00001169)=0.130134809381623E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.86195E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1169 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001169)=0.000000000000000E+00 beta (00001170)=0.135724662549511E+02 gamma(00001170)=0.135724662549511E+02 lr_calc_dens: Charge drift due to real space implementation = 0.28767E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1170 z1= 1 0.132510226859316E-03 0.000000000000000E+00 z1= 2 0.610567500383514E-02 0.000000000000000E+00 z1= 3 -.126362681386899E-03 0.000000000000000E+00 alpha(00001170)=0.000000000000000E+00 beta (00001171)=0.129925660753284E+02 gamma(00001171)=0.129925660753284E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.68960E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1171 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001171)=0.000000000000000E+00 beta (00001172)=0.135814294917558E+02 gamma(00001172)=0.135814294917558E+02 lr_calc_dens: Charge drift due to real space implementation = -0.72911E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1172 z1= 1 -.142250194597167E-03 0.000000000000000E+00 z1= 2 -.602255475871814E-02 0.000000000000000E+00 z1= 3 0.131421607202783E-03 0.000000000000000E+00 alpha(00001172)=0.000000000000000E+00 beta (00001173)=0.128676949935827E+02 gamma(00001173)=0.128676949935827E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.34041E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1173 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001173)=0.000000000000000E+00 beta (00001174)=0.135830252884742E+02 gamma(00001174)=0.135830252884742E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12372E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1174 z1= 1 0.153230542112900E-03 0.000000000000000E+00 z1= 2 0.590154014674757E-02 0.000000000000000E+00 z1= 3 -.135291309304825E-03 0.000000000000000E+00 alpha(00001174)=0.000000000000000E+00 beta (00001175)=0.128574022932039E+02 gamma(00001175)=0.128574022932039E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.84622E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1175 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001175)=0.000000000000000E+00 beta (00001176)=0.135248355213454E+02 gamma(00001176)=0.135248355213454E+02 lr_calc_dens: Charge drift due to real space implementation = -0.53232E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1176 z1= 1 -.159448002500063E-03 0.000000000000000E+00 z1= 2 -.582897551253744E-02 0.000000000000000E+00 z1= 3 0.140187418521024E-03 0.000000000000000E+00 alpha(00001176)=0.000000000000000E+00 beta (00001177)=0.129674918920443E+02 gamma(00001177)=0.129674918920443E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.14868E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1177 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001177)=0.000000000000000E+00 beta (00001178)=0.135125931747804E+02 gamma(00001178)=0.135125931747804E+02 lr_calc_dens: Charge drift due to real space implementation = -0.84454E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1178 z1= 1 0.172691016666617E-03 0.000000000000000E+00 z1= 2 0.577893989114742E-02 0.000000000000000E+00 z1= 3 -.148877539065594E-03 0.000000000000000E+00 alpha(00001178)=0.000000000000000E+00 beta (00001179)=0.129776662364857E+02 gamma(00001179)=0.129776662364857E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.70239E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1179 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001179)=0.000000000000000E+00 beta (00001180)=0.136053160922093E+02 gamma(00001180)=0.136053160922093E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11862E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1180 z1= 1 -.179051705503071E-03 0.000000000000000E+00 z1= 2 -.558690699894739E-02 0.000000000000000E+00 z1= 3 0.156358169272347E-03 0.000000000000000E+00 alpha(00001180)=0.000000000000000E+00 beta (00001181)=0.129369335295448E+02 gamma(00001181)=0.129369335295448E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.24316E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1181 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001181)=0.000000000000000E+00 beta (00001182)=0.135462756349741E+02 gamma(00001182)=0.135462756349741E+02 lr_calc_dens: Charge drift due to real space implementation = -0.65404E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1182 z1= 1 0.186962044286066E-03 0.000000000000000E+00 z1= 2 0.524513044876133E-02 0.000000000000000E+00 z1= 3 -.165948463668277E-03 0.000000000000000E+00 alpha(00001182)=0.000000000000000E+00 beta (00001183)=0.129183996348640E+02 gamma(00001183)=0.129183996348640E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.65096E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1183 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001183)=0.000000000000000E+00 beta (00001184)=0.134710316924660E+02 gamma(00001184)=0.134710316924660E+02 lr_calc_dens: Charge drift due to real space implementation = -0.24027E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1184 z1= 1 -.195279287642993E-03 0.000000000000000E+00 z1= 2 -.483212665918200E-02 0.000000000000000E+00 z1= 3 0.174181545648470E-03 0.000000000000000E+00 alpha(00001184)=0.000000000000000E+00 beta (00001185)=0.129763454008381E+02 gamma(00001185)=0.129763454008381E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.49287E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1185 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001185)=0.000000000000000E+00 beta (00001186)=0.135312268656195E+02 gamma(00001186)=0.135312268656195E+02 lr_calc_dens: Charge drift due to real space implementation = 0.13120E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1186 z1= 1 0.208687763707518E-03 0.000000000000000E+00 z1= 2 0.441939617720590E-02 0.000000000000000E+00 z1= 3 -.184438564320994E-03 0.000000000000000E+00 alpha(00001186)=0.000000000000000E+00 beta (00001187)=0.130159145872423E+02 gamma(00001187)=0.130159145872423E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.14097E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1187 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001187)=0.000000000000000E+00 beta (00001188)=0.135202299622475E+02 gamma(00001188)=0.135202299622475E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10289E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1188 z1= 1 -.221956709974154E-03 0.000000000000000E+00 z1= 2 -.414909865130065E-02 0.000000000000000E+00 z1= 3 0.193671136271163E-03 0.000000000000000E+00 alpha(00001188)=0.000000000000000E+00 beta (00001189)=0.130039421482736E+02 gamma(00001189)=0.130039421482736E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.24148E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1189 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001189)=0.000000000000000E+00 beta (00001190)=0.135439513855265E+02 gamma(00001190)=0.135439513855265E+02 lr_calc_dens: Charge drift due to real space implementation = 0.59901E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1190 z1= 1 0.232438301780176E-03 0.000000000000000E+00 z1= 2 0.401453794483527E-02 0.000000000000000E+00 z1= 3 -.204626405117976E-03 0.000000000000000E+00 alpha(00001190)=0.000000000000000E+00 beta (00001191)=0.129203462344840E+02 gamma(00001191)=0.129203462344840E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.18471E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1191 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001191)=0.000000000000000E+00 beta (00001192)=0.134979780056586E+02 gamma(00001192)=0.134979780056586E+02 lr_calc_dens: Charge drift due to real space implementation = -0.70726E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1192 z1= 1 -.240510190717509E-03 0.000000000000000E+00 z1= 2 -.391343028328979E-02 0.000000000000000E+00 z1= 3 0.212293567118137E-03 0.000000000000000E+00 alpha(00001192)=0.000000000000000E+00 beta (00001193)=0.128523467905447E+02 gamma(00001193)=0.128523467905447E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.92784E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1193 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001193)=0.000000000000000E+00 beta (00001194)=0.135525922883968E+02 gamma(00001194)=0.135525922883968E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12857E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1194 z1= 1 0.252676484604447E-03 0.000000000000000E+00 z1= 2 0.374899345032536E-02 0.000000000000000E+00 z1= 3 -.221819237448582E-03 0.000000000000000E+00 alpha(00001194)=0.000000000000000E+00 beta (00001195)=0.129810616705273E+02 gamma(00001195)=0.129810616705273E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.73087E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1195 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001195)=0.000000000000000E+00 beta (00001196)=0.135246607369648E+02 gamma(00001196)=0.135246607369648E+02 lr_calc_dens: Charge drift due to real space implementation = 0.69408E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1196 z1= 1 -.260313078275925E-03 0.000000000000000E+00 z1= 2 -.358994805205307E-02 0.000000000000000E+00 z1= 3 0.229984889944314E-03 0.000000000000000E+00 alpha(00001196)=0.000000000000000E+00 beta (00001197)=0.130025786848938E+02 gamma(00001197)=0.130025786848938E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.15340E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1197 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001197)=0.000000000000000E+00 beta (00001198)=0.135528954901061E+02 gamma(00001198)=0.135528954901061E+02 lr_calc_dens: Charge drift due to real space implementation = 0.23996E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1198 z1= 1 0.267843948292740E-03 0.000000000000000E+00 z1= 2 0.349186703947519E-02 0.000000000000000E+00 z1= 3 -.242413511480585E-03 0.000000000000000E+00 alpha(00001198)=0.000000000000000E+00 beta (00001199)=0.130027144250621E+02 gamma(00001199)=0.130027144250621E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.23721E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1199 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001199)=0.000000000000000E+00 beta (00001200)=0.134752539564185E+02 gamma(00001200)=0.134752539564185E+02 lr_calc_dens: Charge drift due to real space implementation = -0.81904E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1200 z1= 1 -.278180017667014E-03 0.000000000000000E+00 z1= 2 -.353200810821724E-02 0.000000000000000E+00 z1= 3 0.251285376333508E-03 0.000000000000000E+00 alpha(00001200)=0.000000000000000E+00 beta (00001201)=0.129682517891090E+02 gamma(00001201)=0.129682517891090E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.80352E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1201 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001201)=0.000000000000000E+00 beta (00001202)=0.135089840659177E+02 gamma(00001202)=0.135089840659177E+02 lr_calc_dens: Charge drift due to real space implementation = -0.65199E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1202 z1= 1 0.289534565176268E-03 0.000000000000000E+00 z1= 2 0.371915667679901E-02 0.000000000000000E+00 z1= 3 -.264644622583447E-03 0.000000000000000E+00 alpha(00001202)=0.000000000000000E+00 beta (00001203)=0.129824832040576E+02 gamma(00001203)=0.129824832040576E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.38618E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1203 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001203)=0.000000000000000E+00 beta (00001204)=0.135440855002285E+02 gamma(00001204)=0.135440855002285E+02 lr_calc_dens: Charge drift due to real space implementation = 0.78090E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1204 z1= 1 -.293489389867316E-03 0.000000000000000E+00 z1= 2 -.400768595269379E-02 0.000000000000000E+00 z1= 3 0.271677963239390E-03 0.000000000000000E+00 alpha(00001204)=0.000000000000000E+00 beta (00001205)=0.130295422841603E+02 gamma(00001205)=0.130295422841603E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13703E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1205 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001205)=0.000000000000000E+00 beta (00001206)=0.135517630568937E+02 gamma(00001206)=0.135517630568937E+02 lr_calc_dens: Charge drift due to real space implementation = -0.55673E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1206 z1= 1 0.302433236470374E-03 0.000000000000000E+00 z1= 2 0.428291632656974E-02 0.000000000000000E+00 z1= 3 -.284730141005656E-03 0.000000000000000E+00 alpha(00001206)=0.000000000000000E+00 beta (00001207)=0.129413565806141E+02 gamma(00001207)=0.129413565806141E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.61529E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1207 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001207)=0.000000000000000E+00 beta (00001208)=0.134444114324228E+02 gamma(00001208)=0.134444114324228E+02 lr_calc_dens: Charge drift due to real space implementation = 0.38168E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1208 z1= 1 -.312163387967790E-03 0.000000000000000E+00 z1= 2 -.454355751779996E-02 0.000000000000000E+00 z1= 3 0.291266502554142E-03 0.000000000000000E+00 alpha(00001208)=0.000000000000000E+00 beta (00001209)=0.130432820314403E+02 gamma(00001209)=0.130432820314403E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.84869E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1209 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001209)=0.000000000000000E+00 beta (00001210)=0.135071230772338E+02 gamma(00001210)=0.135071230772338E+02 lr_calc_dens: Charge drift due to real space implementation = 0.87796E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1210 z1= 1 0.327626849188729E-03 0.000000000000000E+00 z1= 2 0.474314800534895E-02 0.000000000000000E+00 z1= 3 -.303919699338386E-03 0.000000000000000E+00 alpha(00001210)=0.000000000000000E+00 beta (00001211)=0.130169578348407E+02 gamma(00001211)=0.130169578348407E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.16980E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1211 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001211)=0.000000000000000E+00 beta (00001212)=0.135464622742761E+02 gamma(00001212)=0.135464622742761E+02 lr_calc_dens: Charge drift due to real space implementation = -0.46289E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1212 z1= 1 -.335979885270725E-03 0.000000000000000E+00 z1= 2 -.480039838852461E-02 0.000000000000000E+00 z1= 3 0.307387413413616E-03 0.000000000000000E+00 alpha(00001212)=0.000000000000000E+00 beta (00001213)=0.129774898795297E+02 gamma(00001213)=0.129774898795297E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.78318E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1213 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001213)=0.000000000000000E+00 beta (00001214)=0.135712462936836E+02 gamma(00001214)=0.135712462936836E+02 lr_calc_dens: Charge drift due to real space implementation = -0.68171E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1214 z1= 1 0.348657744464308E-03 0.000000000000000E+00 z1= 2 0.481938143398087E-02 0.000000000000000E+00 z1= 3 -.317083276156417E-03 0.000000000000000E+00 alpha(00001214)=0.000000000000000E+00 beta (00001215)=0.130292755551273E+02 gamma(00001215)=0.130292755551273E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10563E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1215 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001215)=0.000000000000000E+00 beta (00001216)=0.135503955937520E+02 gamma(00001216)=0.135503955937520E+02 lr_calc_dens: Charge drift due to real space implementation = 0.41188E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1216 z1= 1 -.357575896268373E-03 0.000000000000000E+00 z1= 2 -.499589103935423E-02 0.000000000000000E+00 z1= 3 0.320369247817426E-03 0.000000000000000E+00 alpha(00001216)=0.000000000000000E+00 beta (00001217)=0.130187332737018E+02 gamma(00001217)=0.130187332737018E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.33514E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1217 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001217)=0.000000000000000E+00 beta (00001218)=0.135921030501778E+02 gamma(00001218)=0.135921030501778E+02 lr_calc_dens: Charge drift due to real space implementation = -0.30821E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1218 z1= 1 0.370450316643856E-03 0.000000000000000E+00 z1= 2 0.540054005593386E-02 0.000000000000000E+00 z1= 3 -.331530742785077E-03 0.000000000000000E+00 alpha(00001218)=0.000000000000000E+00 beta (00001219)=0.130583673100407E+02 gamma(00001219)=0.130583673100407E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.14040E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1219 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001219)=0.000000000000000E+00 beta (00001220)=0.135973649336545E+02 gamma(00001220)=0.135973649336545E+02 lr_calc_dens: Charge drift due to real space implementation = -0.46521E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1220 z1= 1 -.378731608982738E-03 0.000000000000000E+00 z1= 2 -.599641533370530E-02 0.000000000000000E+00 z1= 3 0.337516131184247E-03 0.000000000000000E+00 alpha(00001220)=0.000000000000000E+00 beta (00001221)=0.130005065961297E+02 gamma(00001221)=0.130005065961297E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10865E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1221 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001221)=0.000000000000000E+00 beta (00001222)=0.135516662413830E+02 gamma(00001222)=0.135516662413830E+02 lr_calc_dens: Charge drift due to real space implementation = 0.21110E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1222 z1= 1 0.393343745951780E-03 0.000000000000000E+00 z1= 2 0.663634558900931E-02 0.000000000000000E+00 z1= 3 -.352538460124960E-03 0.000000000000000E+00 alpha(00001222)=0.000000000000000E+00 beta (00001223)=0.130222293786242E+02 gamma(00001223)=0.130222293786242E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.80268E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1223 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001223)=0.000000000000000E+00 beta (00001224)=0.135228883555307E+02 gamma(00001224)=0.135228883555307E+02 lr_calc_dens: Charge drift due to real space implementation = -0.22557E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1224 z1= 1 -.402764997701227E-03 0.000000000000000E+00 z1= 2 -.722376813964471E-02 0.000000000000000E+00 z1= 3 0.362717454328475E-03 0.000000000000000E+00 alpha(00001224)=0.000000000000000E+00 beta (00001225)=0.128907789751270E+02 gamma(00001225)=0.128907789751270E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.38628E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1225 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001225)=0.000000000000000E+00 beta (00001226)=0.134344771011835E+02 gamma(00001226)=0.134344771011835E+02 lr_calc_dens: Charge drift due to real space implementation = -0.16455E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1226 z1= 1 0.418636561345398E-03 0.000000000000000E+00 z1= 2 0.756160445863589E-02 0.000000000000000E+00 z1= 3 -.378638836551496E-03 0.000000000000000E+00 alpha(00001226)=0.000000000000000E+00 beta (00001227)=0.130349518910351E+02 gamma(00001227)=0.130349518910351E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.29637E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1227 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001227)=0.000000000000000E+00 beta (00001228)=0.135008087707786E+02 gamma(00001228)=0.135008087707786E+02 lr_calc_dens: Charge drift due to real space implementation = 0.52720E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1228 z1= 1 -.433779492653179E-03 0.000000000000000E+00 z1= 2 -.761295286191222E-02 0.000000000000000E+00 z1= 3 0.390755519889903E-03 0.000000000000000E+00 alpha(00001228)=0.000000000000000E+00 beta (00001229)=0.129813006605836E+02 gamma(00001229)=0.129813006605836E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.37529E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1229 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001229)=0.000000000000000E+00 beta (00001230)=0.136417180385705E+02 gamma(00001230)=0.136417180385705E+02 lr_calc_dens: Charge drift due to real space implementation = 0.59989E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1230 z1= 1 0.445549229519789E-03 0.000000000000000E+00 z1= 2 0.722309465602621E-02 0.000000000000000E+00 z1= 3 -.402872056951742E-03 0.000000000000000E+00 alpha(00001230)=0.000000000000000E+00 beta (00001231)=0.129257727602209E+02 gamma(00001231)=0.129257727602209E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.34645E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1231 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001231)=0.000000000000000E+00 beta (00001232)=0.134862175369223E+02 gamma(00001232)=0.134862175369223E+02 lr_calc_dens: Charge drift due to real space implementation = -0.66003E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1232 z1= 1 -.454459304188709E-03 0.000000000000000E+00 z1= 2 -.666758765791601E-02 0.000000000000000E+00 z1= 3 0.413518884079460E-03 0.000000000000000E+00 alpha(00001232)=0.000000000000000E+00 beta (00001233)=0.130046260995865E+02 gamma(00001233)=0.130046260995865E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.36533E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1233 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001233)=0.000000000000000E+00 beta (00001234)=0.136029066010573E+02 gamma(00001234)=0.136029066010573E+02 lr_calc_dens: Charge drift due to real space implementation = 0.53695E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1234 z1= 1 0.467808053042341E-03 0.000000000000000E+00 z1= 2 0.605794957621139E-02 0.000000000000000E+00 z1= 3 -.427380026015653E-03 0.000000000000000E+00 alpha(00001234)=0.000000000000000E+00 beta (00001235)=0.129265056330675E+02 gamma(00001235)=0.129265056330675E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.96688E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1235 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001235)=0.000000000000000E+00 beta (00001236)=0.135091640162050E+02 gamma(00001236)=0.135091640162050E+02 lr_calc_dens: Charge drift due to real space implementation = 0.71637E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1236 z1= 1 -.478666362371433E-03 0.000000000000000E+00 z1= 2 -.563960418426799E-02 0.000000000000000E+00 z1= 3 0.438556932024662E-03 0.000000000000000E+00 alpha(00001236)=0.000000000000000E+00 beta (00001237)=0.130108260628262E+02 gamma(00001237)=0.130108260628262E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11807E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1237 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001237)=0.000000000000000E+00 beta (00001238)=0.134912467251794E+02 gamma(00001238)=0.134912467251794E+02 lr_calc_dens: Charge drift due to real space implementation = -0.73161E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1238 z1= 1 0.496965869677580E-03 0.000000000000000E+00 z1= 2 0.541061736625330E-02 0.000000000000000E+00 z1= 3 -.456891616450897E-03 0.000000000000000E+00 alpha(00001238)=0.000000000000000E+00 beta (00001239)=0.130223275162140E+02 gamma(00001239)=0.130223275162140E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.60110E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1239 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001239)=0.000000000000000E+00 beta (00001240)=0.135450357245102E+02 gamma(00001240)=0.135450357245102E+02 lr_calc_dens: Charge drift due to real space implementation = 0.78226E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1240 z1= 1 -.510216991133750E-03 0.000000000000000E+00 z1= 2 -.523526154487278E-02 0.000000000000000E+00 z1= 3 0.469336118698113E-03 0.000000000000000E+00 alpha(00001240)=0.000000000000000E+00 beta (00001241)=0.129501278739995E+02 gamma(00001241)=0.129501278739995E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10907E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1241 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001241)=0.000000000000000E+00 beta (00001242)=0.134958296184077E+02 gamma(00001242)=0.134958296184077E+02 lr_calc_dens: Charge drift due to real space implementation = -0.28786E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1242 z1= 1 0.528217693419207E-03 0.000000000000000E+00 z1= 2 0.512460211137486E-02 0.000000000000000E+00 z1= 3 -.482195161210255E-03 0.000000000000000E+00 alpha(00001242)=0.000000000000000E+00 beta (00001243)=0.129247544905484E+02 gamma(00001243)=0.129247544905484E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.44148E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1243 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001243)=0.000000000000000E+00 beta (00001244)=0.134930475026587E+02 gamma(00001244)=0.134930475026587E+02 lr_calc_dens: Charge drift due to real space implementation = 0.61175E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1244 z1= 1 -.539420746951380E-03 0.000000000000000E+00 z1= 2 -.501660172017499E-02 0.000000000000000E+00 z1= 3 0.491590014710464E-03 0.000000000000000E+00 alpha(00001244)=0.000000000000000E+00 beta (00001245)=0.130179697483700E+02 gamma(00001245)=0.130179697483700E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.24256E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1245 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001245)=0.000000000000000E+00 beta (00001246)=0.134986189346484E+02 gamma(00001246)=0.134986189346484E+02 lr_calc_dens: Charge drift due to real space implementation = -0.23255E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1246 z1= 1 0.559323471162318E-03 0.000000000000000E+00 z1= 2 0.492582437745398E-02 0.000000000000000E+00 z1= 3 -.505016041050489E-03 0.000000000000000E+00 alpha(00001246)=0.000000000000000E+00 beta (00001247)=0.130673537803834E+02 gamma(00001247)=0.130673537803834E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10967E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1247 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001247)=0.000000000000000E+00 beta (00001248)=0.135300880737949E+02 gamma(00001248)=0.135300880737949E+02 lr_calc_dens: Charge drift due to real space implementation = 0.29803E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1248 z1= 1 -.575140788879871E-03 0.000000000000000E+00 z1= 2 -.473626556788181E-02 0.000000000000000E+00 z1= 3 0.518050840865276E-03 0.000000000000000E+00 alpha(00001248)=0.000000000000000E+00 beta (00001249)=0.130238349210140E+02 gamma(00001249)=0.130238349210140E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.84437E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1249 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001249)=0.000000000000000E+00 beta (00001250)=0.134727908124153E+02 gamma(00001250)=0.134727908124153E+02 lr_calc_dens: Charge drift due to real space implementation = -0.23285E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1250 z1= 1 0.592941126260967E-03 0.000000000000000E+00 z1= 2 0.445001817933109E-02 0.000000000000000E+00 z1= 3 -.533133349551684E-03 0.000000000000000E+00 alpha(00001250)=0.000000000000000E+00 beta (00001251)=0.130938540680731E+02 gamma(00001251)=0.130938540680731E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.18672E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1251 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001251)=0.000000000000000E+00 beta (00001252)=0.134896503304465E+02 gamma(00001252)=0.134896503304465E+02 lr_calc_dens: Charge drift due to real space implementation = 0.69101E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1252 z1= 1 -.611673172311770E-03 0.000000000000000E+00 z1= 2 -.416854968667772E-02 0.000000000000000E+00 z1= 3 0.549481230996848E-03 0.000000000000000E+00 alpha(00001252)=0.000000000000000E+00 beta (00001253)=0.130178578219265E+02 gamma(00001253)=0.130178578219265E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13138E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1253 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001253)=0.000000000000000E+00 beta (00001254)=0.134873617162885E+02 gamma(00001254)=0.134873617162885E+02 lr_calc_dens: Charge drift due to real space implementation = 0.16845E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1254 z1= 1 0.629796792936430E-03 0.000000000000000E+00 z1= 2 0.388226310547627E-02 0.000000000000000E+00 z1= 3 -.562384961355049E-03 0.000000000000000E+00 alpha(00001254)=0.000000000000000E+00 beta (00001255)=0.130405909850325E+02 gamma(00001255)=0.130405909850325E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.23158E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1255 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001255)=0.000000000000000E+00 beta (00001256)=0.133968504141176E+02 gamma(00001256)=0.133968504141176E+02 lr_calc_dens: Charge drift due to real space implementation = -0.93393E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1256 z1= 1 -.650552793917135E-03 0.000000000000000E+00 z1= 2 -.366151318137033E-02 0.000000000000000E+00 z1= 3 0.581010750352405E-03 0.000000000000000E+00 alpha(00001256)=0.000000000000000E+00 beta (00001257)=0.130420656634162E+02 gamma(00001257)=0.130420656634162E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.43575E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1257 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001257)=0.000000000000000E+00 beta (00001258)=0.134355147582843E+02 gamma(00001258)=0.134355147582843E+02 lr_calc_dens: Charge drift due to real space implementation = -0.29646E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1258 z1= 1 0.670823629931917E-03 0.000000000000000E+00 z1= 2 0.352140796537311E-02 0.000000000000000E+00 z1= 3 -.596904293440372E-03 0.000000000000000E+00 alpha(00001258)=0.000000000000000E+00 beta (00001259)=0.130393511267445E+02 gamma(00001259)=0.130393511267445E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.59476E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1259 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001259)=0.000000000000000E+00 beta (00001260)=0.134867859584337E+02 gamma(00001260)=0.134867859584337E+02 lr_calc_dens: Charge drift due to real space implementation = 0.31798E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1260 z1= 1 -.691262268009802E-03 0.000000000000000E+00 z1= 2 -.338814510531853E-02 0.000000000000000E+00 z1= 3 0.611865645935771E-03 0.000000000000000E+00 alpha(00001260)=0.000000000000000E+00 beta (00001261)=0.130683300793234E+02 gamma(00001261)=0.130683300793234E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.51282E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1261 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001261)=0.000000000000000E+00 beta (00001262)=0.135383291281442E+02 gamma(00001262)=0.135383291281442E+02 lr_calc_dens: Charge drift due to real space implementation = -0.68184E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1262 z1= 1 0.709326027119844E-03 0.000000000000000E+00 z1= 2 0.325426892865735E-02 0.000000000000000E+00 z1= 3 -.623921683002201E-03 0.000000000000000E+00 alpha(00001262)=0.000000000000000E+00 beta (00001263)=0.129950159207451E+02 gamma(00001263)=0.129950159207451E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.14667E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1263 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001263)=0.000000000000000E+00 beta (00001264)=0.134540554127218E+02 gamma(00001264)=0.134540554127218E+02 lr_calc_dens: Charge drift due to real space implementation = 0.24250E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1264 z1= 1 -.726893715806914E-03 0.000000000000000E+00 z1= 2 -.314762869329632E-02 0.000000000000000E+00 z1= 3 0.638125654754998E-03 0.000000000000000E+00 alpha(00001264)=0.000000000000000E+00 beta (00001265)=0.129848287239515E+02 gamma(00001265)=0.129848287239515E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.15231E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1265 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001265)=0.000000000000000E+00 beta (00001266)=0.135178413696706E+02 gamma(00001266)=0.135178413696706E+02 lr_calc_dens: Charge drift due to real space implementation = -0.53253E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1266 z1= 1 0.741258275197039E-03 0.000000000000000E+00 z1= 2 0.312232071174016E-02 0.000000000000000E+00 z1= 3 -.646703758481507E-03 0.000000000000000E+00 alpha(00001266)=0.000000000000000E+00 beta (00001267)=0.129218418269721E+02 gamma(00001267)=0.129218418269721E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12285E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1267 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001267)=0.000000000000000E+00 beta (00001268)=0.135107780690297E+02 gamma(00001268)=0.135107780690297E+02 lr_calc_dens: Charge drift due to real space implementation = 0.48131E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1268 z1= 1 -.750291262075074E-03 0.000000000000000E+00 z1= 2 -.325942965646064E-02 0.000000000000000E+00 z1= 3 0.654321907556911E-03 0.000000000000000E+00 alpha(00001268)=0.000000000000000E+00 beta (00001269)=0.131142142776050E+02 gamma(00001269)=0.131142142776050E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.19988E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1269 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001269)=0.000000000000000E+00 beta (00001270)=0.134528126413474E+02 gamma(00001270)=0.134528126413474E+02 lr_calc_dens: Charge drift due to real space implementation = -0.54965E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1270 z1= 1 0.775570817488988E-03 0.000000000000000E+00 z1= 2 0.358469344187637E-02 0.000000000000000E+00 z1= 3 -.672105106416583E-03 0.000000000000000E+00 alpha(00001270)=0.000000000000000E+00 beta (00001271)=0.130013767650112E+02 gamma(00001271)=0.130013767650112E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.56898E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1271 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001271)=0.000000000000000E+00 beta (00001272)=0.134176705801605E+02 gamma(00001272)=0.134176705801605E+02 lr_calc_dens: Charge drift due to real space implementation = 0.28898E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1272 z1= 1 -.795469518574883E-03 0.000000000000000E+00 z1= 2 -.397046709997885E-02 0.000000000000000E+00 z1= 3 0.687791507504434E-03 0.000000000000000E+00 alpha(00001272)=0.000000000000000E+00 beta (00001273)=0.130107579267557E+02 gamma(00001273)=0.130107579267557E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.92363E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1273 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001273)=0.000000000000000E+00 beta (00001274)=0.133993059882813E+02 gamma(00001274)=0.133993059882813E+02 lr_calc_dens: Charge drift due to real space implementation = 0.57737E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1274 z1= 1 0.820833379074368E-03 0.000000000000000E+00 z1= 2 0.440830497707515E-02 0.000000000000000E+00 z1= 3 -.702478358174236E-03 0.000000000000000E+00 alpha(00001274)=0.000000000000000E+00 beta (00001275)=0.130397664748098E+02 gamma(00001275)=0.130397664748098E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.24678E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1275 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001275)=0.000000000000000E+00 beta (00001276)=0.135838336270028E+02 gamma(00001276)=0.135838336270028E+02 lr_calc_dens: Charge drift due to real space implementation = -0.53402E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1276 z1= 1 -.834328990955403E-03 0.000000000000000E+00 z1= 2 -.472363397906107E-02 0.000000000000000E+00 z1= 3 0.709706372265444E-03 0.000000000000000E+00 alpha(00001276)=0.000000000000000E+00 beta (00001277)=0.129542000056895E+02 gamma(00001277)=0.129542000056895E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.17398E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1277 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001277)=0.000000000000000E+00 beta (00001278)=0.135950727108367E+02 gamma(00001278)=0.135950727108367E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11298E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1278 z1= 1 0.844603236802644E-03 0.000000000000000E+00 z1= 2 0.494383472923432E-02 0.000000000000000E+00 z1= 3 -.710923309277831E-03 0.000000000000000E+00 alpha(00001278)=0.000000000000000E+00 beta (00001279)=0.130135925661012E+02 gamma(00001279)=0.130135925661012E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.20166E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1279 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001279)=0.000000000000000E+00 beta (00001280)=0.136037777063198E+02 gamma(00001280)=0.136037777063198E+02 lr_calc_dens: Charge drift due to real space implementation = -0.96494E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1280 z1= 1 -.854314752831447E-03 0.000000000000000E+00 z1= 2 -.521778896369072E-02 0.000000000000000E+00 z1= 3 0.717873343586608E-03 0.000000000000000E+00 alpha(00001280)=0.000000000000000E+00 beta (00001281)=0.130879164062095E+02 gamma(00001281)=0.130879164062095E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.79049E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1281 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001281)=0.000000000000000E+00 beta (00001282)=0.135001773189490E+02 gamma(00001282)=0.135001773189490E+02 lr_calc_dens: Charge drift due to real space implementation = 0.19797E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1282 z1= 1 0.873917243054911E-03 0.000000000000000E+00 z1= 2 0.555119156891644E-02 0.000000000000000E+00 z1= 3 -.732697856819553E-03 0.000000000000000E+00 alpha(00001282)=0.000000000000000E+00 beta (00001283)=0.130021314967262E+02 gamma(00001283)=0.130021314967262E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.24912E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1283 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001283)=0.000000000000000E+00 beta (00001284)=0.134951080596684E+02 gamma(00001284)=0.134951080596684E+02 lr_calc_dens: Charge drift due to real space implementation = 0.13483E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1284 z1= 1 -.891988337886764E-03 0.000000000000000E+00 z1= 2 -.583959605309498E-02 0.000000000000000E+00 z1= 3 0.745084204493443E-03 0.000000000000000E+00 alpha(00001284)=0.000000000000000E+00 beta (00001285)=0.130726128381442E+02 gamma(00001285)=0.130726128381442E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.41082E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1285 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001285)=0.000000000000000E+00 beta (00001286)=0.135387678307231E+02 gamma(00001286)=0.135387678307231E+02 lr_calc_dens: Charge drift due to real space implementation = -0.45156E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1286 z1= 1 0.909610418312187E-03 0.000000000000000E+00 z1= 2 0.606550476791588E-02 0.000000000000000E+00 z1= 3 -.757344733612989E-03 0.000000000000000E+00 alpha(00001286)=0.000000000000000E+00 beta (00001287)=0.130448056404318E+02 gamma(00001287)=0.130448056404318E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.16683E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1287 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001287)=0.000000000000000E+00 beta (00001288)=0.135145708211819E+02 gamma(00001288)=0.135145708211819E+02 lr_calc_dens: Charge drift due to real space implementation = 0.65553E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1288 z1= 1 -.928036633503539E-03 0.000000000000000E+00 z1= 2 -.616357582116730E-02 0.000000000000000E+00 z1= 3 0.769877369705928E-03 0.000000000000000E+00 alpha(00001288)=0.000000000000000E+00 beta (00001289)=0.130414195829359E+02 gamma(00001289)=0.130414195829359E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.39829E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1289 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001289)=0.000000000000000E+00 beta (00001290)=0.135115615720525E+02 gamma(00001290)=0.135115615720525E+02 lr_calc_dens: Charge drift due to real space implementation = -0.16227E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1290 z1= 1 0.945847648398706E-03 0.000000000000000E+00 z1= 2 0.612845315639657E-02 0.000000000000000E+00 z1= 3 -.780467454855100E-03 0.000000000000000E+00 alpha(00001290)=0.000000000000000E+00 beta (00001291)=0.128836511036678E+02 gamma(00001291)=0.128836511036678E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.34177E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1291 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001291)=0.000000000000000E+00 beta (00001292)=0.135451197408100E+02 gamma(00001292)=0.135451197408100E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11332E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1292 z1= 1 -.951547745810976E-03 0.000000000000000E+00 z1= 2 -.591816724536009E-02 0.000000000000000E+00 z1= 3 0.781851661372860E-03 0.000000000000000E+00 alpha(00001292)=0.000000000000000E+00 beta (00001293)=0.129849473259904E+02 gamma(00001293)=0.129849473259904E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.19779E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1293 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001293)=0.000000000000000E+00 beta (00001294)=0.135142673409988E+02 gamma(00001294)=0.135142673409988E+02 lr_calc_dens: Charge drift due to real space implementation = 0.26777E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1294 z1= 1 0.965641014876525E-03 0.000000000000000E+00 z1= 2 0.583412464402933E-02 0.000000000000000E+00 z1= 3 -.791116580579537E-03 0.000000000000000E+00 alpha(00001294)=0.000000000000000E+00 beta (00001295)=0.129813913547859E+02 gamma(00001295)=0.129813913547859E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10202E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1295 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001295)=0.000000000000000E+00 beta (00001296)=0.135688803824205E+02 gamma(00001296)=0.135688803824205E+02 lr_calc_dens: Charge drift due to real space implementation = -0.46956E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1296 z1= 1 -.978706463188249E-03 0.000000000000000E+00 z1= 2 -.580556132999768E-02 0.000000000000000E+00 z1= 3 0.798817964233706E-03 0.000000000000000E+00 alpha(00001296)=0.000000000000000E+00 beta (00001297)=0.129607354606028E+02 gamma(00001297)=0.129607354606028E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.43251E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1297 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001297)=0.000000000000000E+00 beta (00001298)=0.135301323370059E+02 gamma(00001298)=0.135301323370059E+02 lr_calc_dens: Charge drift due to real space implementation = -0.69215E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1298 z1= 1 0.991404488495605E-03 0.000000000000000E+00 z1= 2 0.585827990418404E-02 0.000000000000000E+00 z1= 3 -.806757991997769E-03 0.000000000000000E+00 alpha(00001298)=0.000000000000000E+00 beta (00001299)=0.129703294420729E+02 gamma(00001299)=0.129703294420729E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.38467E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1299 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001299)=0.000000000000000E+00 beta (00001300)=0.135199464658722E+02 gamma(00001300)=0.135199464658722E+02 lr_calc_dens: Charge drift due to real space implementation = 0.53098E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1300 z1= 1 -.100570312805530E-02 0.000000000000000E+00 z1= 2 -.598384448523403E-02 0.000000000000000E+00 z1= 3 0.817763746855723E-03 0.000000000000000E+00 alpha(00001300)=0.000000000000000E+00 beta (00001301)=0.130061467409837E+02 gamma(00001301)=0.130061467409837E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.21266E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1301 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001301)=0.000000000000000E+00 beta (00001302)=0.135232764460510E+02 gamma(00001302)=0.135232764460510E+02 lr_calc_dens: Charge drift due to real space implementation = -0.36415E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1302 z1= 1 0.102128397826543E-02 0.000000000000000E+00 z1= 2 0.613479606169458E-02 0.000000000000000E+00 z1= 3 -.827945456998973E-03 0.000000000000000E+00 alpha(00001302)=0.000000000000000E+00 beta (00001303)=0.129695029753785E+02 gamma(00001303)=0.129695029753785E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.67189E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1303 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001303)=0.000000000000000E+00 beta (00001304)=0.134824621056756E+02 gamma(00001304)=0.134824621056756E+02 lr_calc_dens: Charge drift due to real space implementation = -0.37273E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1304 z1= 1 -.104065679423802E-02 0.000000000000000E+00 z1= 2 -.630814216453127E-02 0.000000000000000E+00 z1= 3 0.842242028510952E-03 0.000000000000000E+00 alpha(00001304)=0.000000000000000E+00 beta (00001305)=0.130366903759913E+02 gamma(00001305)=0.130366903759913E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.17692E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1305 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001305)=0.000000000000000E+00 beta (00001306)=0.134761627658688E+02 gamma(00001306)=0.134761627658688E+02 lr_calc_dens: Charge drift due to real space implementation = 0.39865E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1306 z1= 1 0.106488784157013E-02 0.000000000000000E+00 z1= 2 0.656073753779106E-02 0.000000000000000E+00 z1= 3 -.857437718271256E-03 0.000000000000000E+00 alpha(00001306)=0.000000000000000E+00 beta (00001307)=0.129803761048769E+02 gamma(00001307)=0.129803761048769E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12511E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1307 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001307)=0.000000000000000E+00 beta (00001308)=0.135065516521065E+02 gamma(00001308)=0.135065516521065E+02 lr_calc_dens: Charge drift due to real space implementation = -0.37914E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1308 z1= 1 -.108325335089455E-02 0.000000000000000E+00 z1= 2 -.672580273334757E-02 0.000000000000000E+00 z1= 3 0.869539935690554E-03 0.000000000000000E+00 alpha(00001308)=0.000000000000000E+00 beta (00001309)=0.129499773205956E+02 gamma(00001309)=0.129499773205956E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.48239E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1309 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001309)=0.000000000000000E+00 beta (00001310)=0.135421517277207E+02 gamma(00001310)=0.135421517277207E+02 lr_calc_dens: Charge drift due to real space implementation = 0.22308E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1310 z1= 1 0.109280638357000E-02 0.000000000000000E+00 z1= 2 0.669430672967136E-02 0.000000000000000E+00 z1= 3 -.873836493969496E-03 0.000000000000000E+00 alpha(00001310)=0.000000000000000E+00 beta (00001311)=0.129995695747672E+02 gamma(00001311)=0.129995695747672E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.75349E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1311 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001311)=0.000000000000000E+00 beta (00001312)=0.134730507370403E+02 gamma(00001312)=0.134730507370403E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10242E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1312 z1= 1 -.110905044403692E-02 0.000000000000000E+00 z1= 2 -.662043494726364E-02 0.000000000000000E+00 z1= 3 0.889703694892132E-03 0.000000000000000E+00 alpha(00001312)=0.000000000000000E+00 beta (00001313)=0.129828079049684E+02 gamma(00001313)=0.129828079049684E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.71541E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1313 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001313)=0.000000000000000E+00 beta (00001314)=0.134835035132640E+02 gamma(00001314)=0.134835035132640E+02 lr_calc_dens: Charge drift due to real space implementation = -0.22350E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1314 z1= 1 0.112748261013399E-02 0.000000000000000E+00 z1= 2 0.651019240915487E-02 0.000000000000000E+00 z1= 3 -.899328173159880E-03 0.000000000000000E+00 alpha(00001314)=0.000000000000000E+00 beta (00001315)=0.131082452389208E+02 gamma(00001315)=0.131082452389208E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.85193E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1315 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001315)=0.000000000000000E+00 beta (00001316)=0.135151960740475E+02 gamma(00001316)=0.135151960740475E+02 lr_calc_dens: Charge drift due to real space implementation = 0.81286E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1316 z1= 1 -.115253730497275E-02 0.000000000000000E+00 z1= 2 -.648381682581876E-02 0.000000000000000E+00 z1= 3 0.919711104890301E-03 0.000000000000000E+00 alpha(00001316)=0.000000000000000E+00 beta (00001317)=0.130092217739342E+02 gamma(00001317)=0.130092217739342E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.15649E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1317 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001317)=0.000000000000000E+00 beta (00001318)=0.135786343652945E+02 gamma(00001318)=0.135786343652945E+02 lr_calc_dens: Charge drift due to real space implementation = -0.57287E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1318 z1= 1 0.116799415605549E-02 0.000000000000000E+00 z1= 2 0.647738914472282E-02 0.000000000000000E+00 z1= 3 -.923788925101989E-03 0.000000000000000E+00 alpha(00001318)=0.000000000000000E+00 beta (00001319)=0.129359753076654E+02 gamma(00001319)=0.129359753076654E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.28163E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1319 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001319)=0.000000000000000E+00 beta (00001320)=0.136434314157262E+02 gamma(00001320)=0.136434314157262E+02 lr_calc_dens: Charge drift due to real space implementation = 0.65577E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1320 z1= 1 -.116933666887345E-02 0.000000000000000E+00 z1= 2 -.648864470419029E-02 0.000000000000000E+00 z1= 3 0.926105400363782E-03 0.000000000000000E+00 alpha(00001320)=0.000000000000000E+00 beta (00001321)=0.130405445550189E+02 gamma(00001321)=0.130405445550189E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.36442E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1321 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001321)=0.000000000000000E+00 beta (00001322)=0.135234217972742E+02 gamma(00001322)=0.135234217972742E+02 lr_calc_dens: Charge drift due to real space implementation = -0.56116E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1322 z1= 1 0.119292192731007E-02 0.000000000000000E+00 z1= 2 0.668728581558330E-02 0.000000000000000E+00 z1= 3 -.938867946436761E-03 0.000000000000000E+00 alpha(00001322)=0.000000000000000E+00 beta (00001323)=0.130173797764883E+02 gamma(00001323)=0.130173797764883E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.97839E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1323 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001323)=0.000000000000000E+00 beta (00001324)=0.135214312014680E+02 gamma(00001324)=0.135214312014680E+02 lr_calc_dens: Charge drift due to real space implementation = -0.41866E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1324 z1= 1 -.121393137450404E-02 0.000000000000000E+00 z1= 2 -.687236343668148E-02 0.000000000000000E+00 z1= 3 0.956480998481397E-03 0.000000000000000E+00 alpha(00001324)=0.000000000000000E+00 beta (00001325)=0.129532681122364E+02 gamma(00001325)=0.129532681122364E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.39067E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1325 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001325)=0.000000000000000E+00 beta (00001326)=0.136096123005760E+02 gamma(00001326)=0.136096123005760E+02 lr_calc_dens: Charge drift due to real space implementation = 0.65265E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1326 z1= 1 0.122186399948062E-02 0.000000000000000E+00 z1= 2 0.687328605567117E-02 0.000000000000000E+00 z1= 3 -.957597210636254E-03 0.000000000000000E+00 alpha(00001326)=0.000000000000000E+00 beta (00001327)=0.128428747799240E+02 gamma(00001327)=0.128428747799240E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.32811E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1327 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001327)=0.000000000000000E+00 beta (00001328)=0.135616819164341E+02 gamma(00001328)=0.135616819164341E+02 lr_calc_dens: Charge drift due to real space implementation = -0.25254E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1328 z1= 1 -.122358610556668E-02 0.000000000000000E+00 z1= 2 -.684270764648242E-02 0.000000000000000E+00 z1= 3 0.962781596674791E-03 0.000000000000000E+00 alpha(00001328)=0.000000000000000E+00 beta (00001329)=0.129850009153279E+02 gamma(00001329)=0.129850009153279E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.53444E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1329 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001329)=0.000000000000000E+00 beta (00001330)=0.135577110468525E+02 gamma(00001330)=0.135577110468525E+02 lr_calc_dens: Charge drift due to real space implementation = -0.15703E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1330 z1= 1 0.123730882423311E-02 0.000000000000000E+00 z1= 2 0.690702792983273E-02 0.000000000000000E+00 z1= 3 -.972947665259496E-03 0.000000000000000E+00 alpha(00001330)=0.000000000000000E+00 beta (00001331)=0.128680751277451E+02 gamma(00001331)=0.128680751277451E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.64168E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1331 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001331)=0.000000000000000E+00 beta (00001332)=0.135478333272060E+02 gamma(00001332)=0.135478333272060E+02 lr_calc_dens: Charge drift due to real space implementation = 0.31288E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1332 z1= 1 -.124652035414610E-02 0.000000000000000E+00 z1= 2 -.681253836046627E-02 0.000000000000000E+00 z1= 3 0.984010673706707E-03 0.000000000000000E+00 alpha(00001332)=0.000000000000000E+00 beta (00001333)=0.129431462023080E+02 gamma(00001333)=0.129431462023080E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.57505E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1333 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001333)=0.000000000000000E+00 beta (00001334)=0.135843215469094E+02 gamma(00001334)=0.135843215469094E+02 lr_calc_dens: Charge drift due to real space implementation = -0.64139E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1334 z1= 1 0.125917556735690E-02 0.000000000000000E+00 z1= 2 0.658115583631750E-02 0.000000000000000E+00 z1= 3 -.992879637318810E-03 0.000000000000000E+00 alpha(00001334)=0.000000000000000E+00 beta (00001335)=0.130132587409224E+02 gamma(00001335)=0.130132587409224E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.24498E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1335 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001335)=0.000000000000000E+00 beta (00001336)=0.135994448548998E+02 gamma(00001336)=0.135994448548998E+02 lr_calc_dens: Charge drift due to real space implementation = 0.85882E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1336 z1= 1 -.127599792629235E-02 0.000000000000000E+00 z1= 2 -.636592356825330E-02 0.000000000000000E+00 z1= 3 0.101190533790807E-02 0.000000000000000E+00 alpha(00001336)=0.000000000000000E+00 beta (00001337)=0.129582226250439E+02 gamma(00001337)=0.129582226250439E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.44138E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1337 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001337)=0.000000000000000E+00 beta (00001338)=0.135359047135882E+02 gamma(00001338)=0.135359047135882E+02 lr_calc_dens: Charge drift due to real space implementation = -0.46258E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1338 z1= 1 0.129634851195493E-02 0.000000000000000E+00 z1= 2 0.627834912978162E-02 0.000000000000000E+00 z1= 3 -.102568588497071E-02 0.000000000000000E+00 alpha(00001338)=0.000000000000000E+00 beta (00001339)=0.128585643557639E+02 gamma(00001339)=0.128585643557639E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.91260E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1339 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001339)=0.000000000000000E+00 beta (00001340)=0.135181198449366E+02 gamma(00001340)=0.135181198449366E+02 lr_calc_dens: Charge drift due to real space implementation = -0.57555E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1340 z1= 1 -.131445242283971E-02 0.000000000000000E+00 z1= 2 -.619742510130846E-02 0.000000000000000E+00 z1= 3 0.103993529759728E-02 0.000000000000000E+00 alpha(00001340)=0.000000000000000E+00 beta (00001341)=0.129541406636933E+02 gamma(00001341)=0.129541406636933E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12431E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1341 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001341)=0.000000000000000E+00 beta (00001342)=0.136060041630727E+02 gamma(00001342)=0.136060041630727E+02 lr_calc_dens: Charge drift due to real space implementation = 0.54723E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1342 z1= 1 0.132839968533844E-02 0.000000000000000E+00 z1= 2 0.614620948699050E-02 0.000000000000000E+00 z1= 3 -.105066575419202E-02 0.000000000000000E+00 alpha(00001342)=0.000000000000000E+00 beta (00001343)=0.128490262056454E+02 gamma(00001343)=0.128490262056454E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.49616E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1343 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001343)=0.000000000000000E+00 beta (00001344)=0.136258075452181E+02 gamma(00001344)=0.136258075452181E+02 lr_calc_dens: Charge drift due to real space implementation = 0.86198E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1344 z1= 1 -.133158634709655E-02 0.000000000000000E+00 z1= 2 -.600969626819608E-02 0.000000000000000E+00 z1= 3 0.105839838596718E-02 0.000000000000000E+00 alpha(00001344)=0.000000000000000E+00 beta (00001345)=0.129203979002622E+02 gamma(00001345)=0.129203979002622E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.51496E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1345 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001345)=0.000000000000000E+00 beta (00001346)=0.135776779958792E+02 gamma(00001346)=0.135776779958792E+02 lr_calc_dens: Charge drift due to real space implementation = -0.63501E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1346 z1= 1 0.134859424025133E-02 0.000000000000000E+00 z1= 2 0.582372810311180E-02 0.000000000000000E+00 z1= 3 -.107272181662514E-02 0.000000000000000E+00 alpha(00001346)=0.000000000000000E+00 beta (00001347)=0.129698335588390E+02 gamma(00001347)=0.129698335588390E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.81315E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1347 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001347)=0.000000000000000E+00 beta (00001348)=0.134348272936810E+02 gamma(00001348)=0.134348272936810E+02 lr_calc_dens: Charge drift due to real space implementation = 0.66728E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1348 z1= 1 -.138944594935366E-02 0.000000000000000E+00 z1= 2 -.560684436311412E-02 0.000000000000000E+00 z1= 3 0.110901066572210E-02 0.000000000000000E+00 alpha(00001348)=0.000000000000000E+00 beta (00001349)=0.129287537968028E+02 gamma(00001349)=0.129287537968028E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.33015E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1349 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001349)=0.000000000000000E+00 beta (00001350)=0.135007493563389E+02 gamma(00001350)=0.135007493563389E+02 lr_calc_dens: Charge drift due to real space implementation = -0.32293E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1350 z1= 1 0.142036740846576E-02 0.000000000000000E+00 z1= 2 0.527982683501010E-02 0.000000000000000E+00 z1= 3 -.113085333666497E-02 0.000000000000000E+00 alpha(00001350)=0.000000000000000E+00 beta (00001351)=0.129214892882367E+02 gamma(00001351)=0.129214892882367E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.40241E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1351 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001351)=0.000000000000000E+00 beta (00001352)=0.135011677316777E+02 gamma(00001352)=0.135011677316777E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10451E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1352 z1= 1 -.145193878001952E-02 0.000000000000000E+00 z1= 2 -.495783124591012E-02 0.000000000000000E+00 z1= 3 0.115765971552026E-02 0.000000000000000E+00 alpha(00001352)=0.000000000000000E+00 beta (00001353)=0.130026206686276E+02 gamma(00001353)=0.130026206686276E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.43954E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1353 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001353)=0.000000000000000E+00 beta (00001354)=0.134661723879860E+02 gamma(00001354)=0.134661723879860E+02 lr_calc_dens: Charge drift due to real space implementation = 0.16209E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1354 z1= 1 0.149080718774187E-02 0.000000000000000E+00 z1= 2 0.475693317466073E-02 0.000000000000000E+00 z1= 3 -.118930046669340E-02 0.000000000000000E+00 alpha(00001354)=0.000000000000000E+00 beta (00001355)=0.129467644670346E+02 gamma(00001355)=0.129467644670346E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.32523E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1355 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001355)=0.000000000000000E+00 beta (00001356)=0.135549153348666E+02 gamma(00001356)=0.135549153348666E+02 lr_calc_dens: Charge drift due to real space implementation = -0.35587E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1356 z1= 1 -.151611032649114E-02 0.000000000000000E+00 z1= 2 -.449034705878767E-02 0.000000000000000E+00 z1= 3 0.121433038863652E-02 0.000000000000000E+00 alpha(00001356)=0.000000000000000E+00 beta (00001357)=0.129636668428687E+02 gamma(00001357)=0.129636668428687E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.69841E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1357 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001357)=0.000000000000000E+00 beta (00001358)=0.134914547815982E+02 gamma(00001358)=0.134914547815982E+02 lr_calc_dens: Charge drift due to real space implementation = 0.30364E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1358 z1= 1 0.155206583036888E-02 0.000000000000000E+00 z1= 2 0.424494359962775E-02 0.000000000000000E+00 z1= 3 -.124252358535133E-02 0.000000000000000E+00 alpha(00001358)=0.000000000000000E+00 beta (00001359)=0.129970163222845E+02 gamma(00001359)=0.129970163222845E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.62250E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1359 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001359)=0.000000000000000E+00 beta (00001360)=0.135584709065692E+02 gamma(00001360)=0.135584709065692E+02 lr_calc_dens: Charge drift due to real space implementation = -0.27043E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1360 z1= 1 -.158852415149375E-02 0.000000000000000E+00 z1= 2 -.412474818415463E-02 0.000000000000000E+00 z1= 3 0.127386856622431E-02 0.000000000000000E+00 alpha(00001360)=0.000000000000000E+00 beta (00001361)=0.130013669116054E+02 gamma(00001361)=0.130013669116054E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.18697E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1361 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001361)=0.000000000000000E+00 beta (00001362)=0.136138946944787E+02 gamma(00001362)=0.136138946944787E+02 lr_calc_dens: Charge drift due to real space implementation = 0.42911E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1362 z1= 1 0.161559486637949E-02 0.000000000000000E+00 z1= 2 0.410774908856296E-02 0.000000000000000E+00 z1= 3 -.129565934048450E-02 0.000000000000000E+00 alpha(00001362)=0.000000000000000E+00 beta (00001363)=0.130135894151656E+02 gamma(00001363)=0.130135894151656E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.89249E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1363 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001363)=0.000000000000000E+00 beta (00001364)=0.134938267122028E+02 gamma(00001364)=0.134938267122028E+02 lr_calc_dens: Charge drift due to real space implementation = 0.27964E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1364 z1= 1 -.166268750116014E-02 0.000000000000000E+00 z1= 2 -.421738030193326E-02 0.000000000000000E+00 z1= 3 0.133756180782924E-02 0.000000000000000E+00 alpha(00001364)=0.000000000000000E+00 beta (00001365)=0.130069834793851E+02 gamma(00001365)=0.130069834793851E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10013E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1365 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001365)=0.000000000000000E+00 beta (00001366)=0.134985473464749E+02 gamma(00001366)=0.134985473464749E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12990E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1366 z1= 1 0.170791245926886E-02 0.000000000000000E+00 z1= 2 0.419367713117957E-02 0.000000000000000E+00 z1= 3 -.137216757584000E-02 0.000000000000000E+00 alpha(00001366)=0.000000000000000E+00 beta (00001367)=0.129616128118085E+02 gamma(00001367)=0.129616128118085E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.17185E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1367 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001367)=0.000000000000000E+00 beta (00001368)=0.135143774084314E+02 gamma(00001368)=0.135143774084314E+02 lr_calc_dens: Charge drift due to real space implementation = 0.85806E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1368 z1= 1 -.174151637694931E-02 0.000000000000000E+00 z1= 2 -.397879430984680E-02 0.000000000000000E+00 z1= 3 0.140504229471728E-02 0.000000000000000E+00 alpha(00001368)=0.000000000000000E+00 beta (00001369)=0.129441504123624E+02 gamma(00001369)=0.129441504123624E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.74917E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1369 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001369)=0.000000000000000E+00 beta (00001370)=0.135194060667578E+02 gamma(00001370)=0.135194060667578E+02 lr_calc_dens: Charge drift due to real space implementation = -0.26177E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1370 z1= 1 0.177452799381003E-02 0.000000000000000E+00 z1= 2 0.376247475806772E-02 0.000000000000000E+00 z1= 3 -.143003477898724E-02 0.000000000000000E+00 alpha(00001370)=0.000000000000000E+00 beta (00001371)=0.129941436523271E+02 gamma(00001371)=0.129941436523271E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.59063E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1371 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001371)=0.000000000000000E+00 beta (00001372)=0.135322699570902E+02 gamma(00001372)=0.135322699570902E+02 lr_calc_dens: Charge drift due to real space implementation = -0.47072E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1372 z1= 1 -.181293286067409E-02 0.000000000000000E+00 z1= 2 -.355306408712107E-02 0.000000000000000E+00 z1= 3 0.146418062824397E-02 0.000000000000000E+00 alpha(00001372)=0.000000000000000E+00 beta (00001373)=0.129276906649710E+02 gamma(00001373)=0.129276906649710E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12467E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1373 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001373)=0.000000000000000E+00 beta (00001374)=0.136765779700703E+02 gamma(00001374)=0.136765779700703E+02 lr_calc_dens: Charge drift due to real space implementation = 0.27376E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1374 z1= 1 0.182689982520671E-02 0.000000000000000E+00 z1= 2 0.326006741116523E-02 0.000000000000000E+00 z1= 3 -.147106043157788E-02 0.000000000000000E+00 alpha(00001374)=0.000000000000000E+00 beta (00001375)=0.129739743112814E+02 gamma(00001375)=0.129739743112814E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.40865E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1375 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001375)=0.000000000000000E+00 beta (00001376)=0.136001798935317E+02 gamma(00001376)=0.136001798935317E+02 lr_calc_dens: Charge drift due to real space implementation = 0.38789E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1376 z1= 1 -.185471989463937E-02 0.000000000000000E+00 z1= 2 -.297006863964546E-02 0.000000000000000E+00 z1= 3 0.149745568785157E-02 0.000000000000000E+00 alpha(00001376)=0.000000000000000E+00 beta (00001377)=0.130269084191577E+02 gamma(00001377)=0.130269084191577E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.11619E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1377 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001377)=0.000000000000000E+00 beta (00001378)=0.135478625307567E+02 gamma(00001378)=0.135478625307567E+02 lr_calc_dens: Charge drift due to real space implementation = -0.13229E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1378 z1= 1 0.189870496452612E-02 0.000000000000000E+00 z1= 2 0.268489887855761E-02 0.000000000000000E+00 z1= 3 -.153174920125326E-02 0.000000000000000E+00 alpha(00001378)=0.000000000000000E+00 beta (00001379)=0.130012717173729E+02 gamma(00001379)=0.130012717173729E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.17461E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1379 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001379)=0.000000000000000E+00 beta (00001380)=0.136009937376500E+02 gamma(00001380)=0.136009937376500E+02 lr_calc_dens: Charge drift due to real space implementation = -0.31088E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1380 z1= 1 -.193066889107592E-02 0.000000000000000E+00 z1= 2 -.232660352348274E-02 0.000000000000000E+00 z1= 3 0.156068803314565E-02 0.000000000000000E+00 alpha(00001380)=0.000000000000000E+00 beta (00001381)=0.130610043890936E+02 gamma(00001381)=0.130610043890936E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.55123E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1381 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001381)=0.000000000000000E+00 beta (00001382)=0.134474535379102E+02 gamma(00001382)=0.134474535379102E+02 lr_calc_dens: Charge drift due to real space implementation = -0.40444E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1382 z1= 1 0.200086186813867E-02 0.000000000000000E+00 z1= 2 0.197373093512026E-02 0.000000000000000E+00 z1= 3 -.161361160745761E-02 0.000000000000000E+00 alpha(00001382)=0.000000000000000E+00 beta (00001383)=0.129875854169798E+02 gamma(00001383)=0.129875854169798E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.24561E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1383 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001383)=0.000000000000000E+00 beta (00001384)=0.135108685808852E+02 gamma(00001384)=0.135108685808852E+02 lr_calc_dens: Charge drift due to real space implementation = 0.84027E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1384 z1= 1 -.204304584167480E-02 0.000000000000000E+00 z1= 2 -.162188201084986E-02 0.000000000000000E+00 z1= 3 0.165232178334005E-02 0.000000000000000E+00 alpha(00001384)=0.000000000000000E+00 beta (00001385)=0.130794266395298E+02 gamma(00001385)=0.130794266395298E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.64885E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1385 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001385)=0.000000000000000E+00 beta (00001386)=0.135050583763856E+02 gamma(00001386)=0.135050583763856E+02 lr_calc_dens: Charge drift due to real space implementation = -0.24192E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1386 z1= 1 0.210564988099266E-02 0.000000000000000E+00 z1= 2 0.119229378138307E-02 0.000000000000000E+00 z1= 3 -.170204534807460E-02 0.000000000000000E+00 alpha(00001386)=0.000000000000000E+00 beta (00001387)=0.130253699048441E+02 gamma(00001387)=0.130253699048441E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.78788E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1387 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001387)=0.000000000000000E+00 beta (00001388)=0.134032013061759E+02 gamma(00001388)=0.134032013061759E+02 lr_calc_dens: Charge drift due to real space implementation = -0.43418E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1388 z1= 1 -.217316520453770E-02 0.000000000000000E+00 z1= 2 -.655756337199186E-03 0.000000000000000E+00 z1= 3 0.175842214688206E-02 0.000000000000000E+00 alpha(00001388)=0.000000000000000E+00 beta (00001389)=0.130756767813395E+02 gamma(00001389)=0.130756767813395E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.25320E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1389 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001389)=0.000000000000000E+00 beta (00001390)=0.134601052317125E+02 gamma(00001390)=0.134601052317125E+02 lr_calc_dens: Charge drift due to real space implementation = 0.44644E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1390 z1= 1 0.224032542263904E-02 0.000000000000000E+00 z1= 2 0.132067629686483E-03 0.000000000000000E+00 z1= 3 -.181435295510370E-02 0.000000000000000E+00 alpha(00001390)=0.000000000000000E+00 beta (00001391)=0.131201834578045E+02 gamma(00001391)=0.131201834578045E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.44252E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1391 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001391)=0.000000000000000E+00 beta (00001392)=0.134648235619104E+02 gamma(00001392)=0.134648235619104E+02 lr_calc_dens: Charge drift due to real space implementation = -0.38702E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1392 z1= 1 -.230877628258365E-02 0.000000000000000E+00 z1= 2 0.320537213862289E-03 0.000000000000000E+00 z1= 3 0.187392007869982E-02 0.000000000000000E+00 alpha(00001392)=0.000000000000000E+00 beta (00001393)=0.129333330325657E+02 gamma(00001393)=0.129333330325657E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.41666E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1393 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001393)=0.000000000000000E+00 beta (00001394)=0.134771884723320E+02 gamma(00001394)=0.134771884723320E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10579E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1394 z1= 1 0.234285920831324E-02 0.000000000000000E+00 z1= 2 -.657152070399702E-03 0.000000000000000E+00 z1= 3 -.190897835211290E-02 0.000000000000000E+00 alpha(00001394)=0.000000000000000E+00 beta (00001395)=0.130859118078141E+02 gamma(00001395)=0.130859118078141E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.70670E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1395 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001395)=0.000000000000000E+00 beta (00001396)=0.135025769851236E+02 gamma(00001396)=0.135025769851236E+02 lr_calc_dens: Charge drift due to real space implementation = 0.46262E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1396 z1= 1 -.239911297416398E-02 0.000000000000000E+00 z1= 2 0.881015598880098E-03 0.000000000000000E+00 z1= 3 0.195805429703896E-02 0.000000000000000E+00 alpha(00001396)=0.000000000000000E+00 beta (00001397)=0.129204402333961E+02 gamma(00001397)=0.129204402333961E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.60443E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1397 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001397)=0.000000000000000E+00 beta (00001398)=0.134826057461519E+02 gamma(00001398)=0.134826057461519E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11767E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1398 z1= 1 0.242806681247689E-02 0.000000000000000E+00 z1= 2 -.991408454599684E-03 0.000000000000000E+00 z1= 3 -.199086791053437E-02 0.000000000000000E+00 alpha(00001398)=0.000000000000000E+00 beta (00001399)=0.129647316468792E+02 gamma(00001399)=0.129647316468792E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.41909E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1399 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001399)=0.000000000000000E+00 beta (00001400)=0.135650800259748E+02 gamma(00001400)=0.135650800259748E+02 lr_calc_dens: Charge drift due to real space implementation = 0.93358E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1400 z1= 1 -.245289712280755E-02 0.000000000000000E+00 z1= 2 0.102345768882828E-02 0.000000000000000E+00 z1= 3 0.201259817165153E-02 0.000000000000000E+00 alpha(00001400)=0.000000000000000E+00 beta (00001401)=0.129971533165148E+02 gamma(00001401)=0.129971533165148E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13467E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1401 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001401)=0.000000000000000E+00 beta (00001402)=0.135036378426011E+02 gamma(00001402)=0.135036378426011E+02 lr_calc_dens: Charge drift due to real space implementation = 0.13170E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1402 z1= 1 0.249626938106382E-02 0.000000000000000E+00 z1= 2 -.109481350360676E-02 0.000000000000000E+00 z1= 3 -.205652440602146E-02 0.000000000000000E+00 alpha(00001402)=0.000000000000000E+00 beta (00001403)=0.129756958050874E+02 gamma(00001403)=0.129756958050874E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12664E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1403 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001403)=0.000000000000000E+00 beta (00001404)=0.135588755812766E+02 gamma(00001404)=0.135588755812766E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10132E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1404 z1= 1 -.252674997569698E-02 0.000000000000000E+00 z1= 2 0.122637325446259E-02 0.000000000000000E+00 z1= 3 0.208076584333240E-02 0.000000000000000E+00 alpha(00001404)=0.000000000000000E+00 beta (00001405)=0.129675971141361E+02 gamma(00001405)=0.129675971141361E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.40534E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1405 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001405)=0.000000000000000E+00 beta (00001406)=0.134891236342346E+02 gamma(00001406)=0.134891236342346E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11276E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1406 z1= 1 0.256724622519673E-02 0.000000000000000E+00 z1= 2 -.146055040544643E-02 0.000000000000000E+00 z1= 3 -.212408275908972E-02 0.000000000000000E+00 alpha(00001406)=0.000000000000000E+00 beta (00001407)=0.130254080015853E+02 gamma(00001407)=0.130254080015853E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.64650E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1407 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001407)=0.000000000000000E+00 beta (00001408)=0.135119888220039E+02 gamma(00001408)=0.135119888220039E+02 lr_calc_dens: Charge drift due to real space implementation = -0.28407E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1408 z1= 1 -.261391900352574E-02 0.000000000000000E+00 z1= 2 0.179005476810770E-02 0.000000000000000E+00 z1= 3 0.216438830165880E-02 0.000000000000000E+00 alpha(00001408)=0.000000000000000E+00 beta (00001409)=0.129799289390334E+02 gamma(00001409)=0.129799289390334E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.96253E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1409 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001409)=0.000000000000000E+00 beta (00001410)=0.135694748854788E+02 gamma(00001410)=0.135694748854788E+02 lr_calc_dens: Charge drift due to real space implementation = -0.76355E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1410 z1= 1 0.264047083911222E-02 0.000000000000000E+00 z1= 2 -.214717137994679E-02 0.000000000000000E+00 z1= 3 -.219854922355334E-02 0.000000000000000E+00 alpha(00001410)=0.000000000000000E+00 beta (00001411)=0.130312111167629E+02 gamma(00001411)=0.130312111167629E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.32246E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1411 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001411)=0.000000000000000E+00 beta (00001412)=0.135198549510425E+02 gamma(00001412)=0.135198549510425E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12003E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1412 z1= 1 -.269317165873796E-02 0.000000000000000E+00 z1= 2 0.250615465618167E-02 0.000000000000000E+00 z1= 3 0.223905622069592E-02 0.000000000000000E+00 alpha(00001412)=0.000000000000000E+00 beta (00001413)=0.129374796569135E+02 gamma(00001413)=0.129374796569135E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.84062E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1413 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001413)=0.000000000000000E+00 beta (00001414)=0.135087656306037E+02 gamma(00001414)=0.135087656306037E+02 lr_calc_dens: Charge drift due to real space implementation = -0.44282E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1414 z1= 1 0.272482156694900E-02 0.000000000000000E+00 z1= 2 -.268395685677923E-02 0.000000000000000E+00 z1= 3 -.227721033739274E-02 0.000000000000000E+00 alpha(00001414)=0.000000000000000E+00 beta (00001415)=0.129106685268575E+02 gamma(00001415)=0.129106685268575E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12398E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1415 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001415)=0.000000000000000E+00 beta (00001416)=0.136061356647167E+02 gamma(00001416)=0.136061356647167E+02 lr_calc_dens: Charge drift due to real space implementation = -0.62260E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1416 z1= 1 -.273732578010253E-02 0.000000000000000E+00 z1= 2 0.258733201778394E-02 0.000000000000000E+00 z1= 3 0.228448648607237E-02 0.000000000000000E+00 alpha(00001416)=0.000000000000000E+00 beta (00001417)=0.129456095025079E+02 gamma(00001417)=0.129456095025079E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.57400E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1417 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001417)=0.000000000000000E+00 beta (00001418)=0.135268082805504E+02 gamma(00001418)=0.135268082805504E+02 lr_calc_dens: Charge drift due to real space implementation = 0.93201E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1418 z1= 1 0.276877623027183E-02 0.000000000000000E+00 z1= 2 -.238769204487203E-02 0.000000000000000E+00 z1= 3 -.232686680442197E-02 0.000000000000000E+00 alpha(00001418)=0.000000000000000E+00 beta (00001419)=0.129756249561620E+02 gamma(00001419)=0.129756249561620E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.57393E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1419 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001419)=0.000000000000000E+00 beta (00001420)=0.135596997407567E+02 gamma(00001420)=0.135596997407567E+02 lr_calc_dens: Charge drift due to real space implementation = 0.25169E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1420 z1= 1 -.281103753484399E-02 0.000000000000000E+00 z1= 2 0.218654654911463E-02 0.000000000000000E+00 z1= 3 0.235735828174150E-02 0.000000000000000E+00 alpha(00001420)=0.000000000000000E+00 beta (00001421)=0.128848829994697E+02 gamma(00001421)=0.128848829994697E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.21033E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1421 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001421)=0.000000000000000E+00 beta (00001422)=0.135666306110738E+02 gamma(00001422)=0.135666306110738E+02 lr_calc_dens: Charge drift due to real space implementation = -0.88005E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1422 z1= 1 0.282623948334332E-02 0.000000000000000E+00 z1= 2 -.210455964815250E-02 0.000000000000000E+00 z1= 3 -.238595414163209E-02 0.000000000000000E+00 alpha(00001422)=0.000000000000000E+00 beta (00001423)=0.129790312706925E+02 gamma(00001423)=0.129790312706925E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.93944E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1423 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001423)=0.000000000000000E+00 beta (00001424)=0.135647564480780E+02 gamma(00001424)=0.135647564480780E+02 lr_calc_dens: Charge drift due to real space implementation = 0.57808E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1424 z1= 1 -.287203164977565E-02 0.000000000000000E+00 z1= 2 0.223247039971491E-02 0.000000000000000E+00 z1= 3 0.241910896645957E-02 0.000000000000000E+00 alpha(00001424)=0.000000000000000E+00 beta (00001425)=0.129509104102444E+02 gamma(00001425)=0.129509104102444E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.11243E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1425 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001425)=0.000000000000000E+00 beta (00001426)=0.135142424129408E+02 gamma(00001426)=0.135142424129408E+02 lr_calc_dens: Charge drift due to real space implementation = 0.98811E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1426 z1= 1 0.291594396996916E-02 0.000000000000000E+00 z1= 2 -.250184058735704E-02 0.000000000000000E+00 z1= 3 -.247356741167996E-02 0.000000000000000E+00 alpha(00001426)=0.000000000000000E+00 beta (00001427)=0.129763826495213E+02 gamma(00001427)=0.129763826495213E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.14596E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1427 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001427)=0.000000000000000E+00 beta (00001428)=0.135805478384222E+02 gamma(00001428)=0.135805478384222E+02 lr_calc_dens: Charge drift due to real space implementation = -0.96969E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1428 z1= 1 -.296076926038642E-02 0.000000000000000E+00 z1= 2 0.285522475506326E-02 0.000000000000000E+00 z1= 3 0.250778254169249E-02 0.000000000000000E+00 alpha(00001428)=0.000000000000000E+00 beta (00001429)=0.130172015831604E+02 gamma(00001429)=0.130172015831604E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.81264E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1429 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001429)=0.000000000000000E+00 beta (00001430)=0.136805330473847E+02 gamma(00001430)=0.136805330473847E+02 lr_calc_dens: Charge drift due to real space implementation = 0.45350E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1430 z1= 1 0.298435778699433E-02 0.000000000000000E+00 z1= 2 -.315923697239966E-02 0.000000000000000E+00 z1= 3 -.254880214939077E-02 0.000000000000000E+00 alpha(00001430)=0.000000000000000E+00 beta (00001431)=0.130553069576656E+02 gamma(00001431)=0.130553069576656E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.86336E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1431 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001431)=0.000000000000000E+00 beta (00001432)=0.135663760093133E+02 gamma(00001432)=0.135663760093133E+02 lr_calc_dens: Charge drift due to real space implementation = 0.93834E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1432 z1= 1 -.305205695523491E-02 0.000000000000000E+00 z1= 2 0.337449302838303E-02 0.000000000000000E+00 z1= 3 0.260713260456127E-02 0.000000000000000E+00 alpha(00001432)=0.000000000000000E+00 beta (00001433)=0.130393152305308E+02 gamma(00001433)=0.130393152305308E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.21289E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1433 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001433)=0.000000000000000E+00 beta (00001434)=0.135187263391060E+02 gamma(00001434)=0.135187263391060E+02 lr_calc_dens: Charge drift due to real space implementation = -0.71980E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1434 z1= 1 0.312115451433956E-02 0.000000000000000E+00 z1= 2 -.357817503694504E-02 0.000000000000000E+00 z1= 3 -.268618120274454E-02 0.000000000000000E+00 alpha(00001434)=0.000000000000000E+00 beta (00001435)=0.130718966785189E+02 gamma(00001435)=0.130718966785189E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.89938E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1435 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001435)=0.000000000000000E+00 beta (00001436)=0.134429510411386E+02 gamma(00001436)=0.134429510411386E+02 lr_calc_dens: Charge drift due to real space implementation = 0.22813E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1436 z1= 1 -.322228779304738E-02 0.000000000000000E+00 z1= 2 0.384109171241018E-02 0.000000000000000E+00 z1= 3 0.277550743895990E-02 0.000000000000000E+00 alpha(00001436)=0.000000000000000E+00 beta (00001437)=0.130756326030938E+02 gamma(00001437)=0.130756326030938E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.81731E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1437 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001437)=0.000000000000000E+00 beta (00001438)=0.135946409814828E+02 gamma(00001438)=0.135946409814828E+02 lr_calc_dens: Charge drift due to real space implementation = 0.31647E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1438 z1= 1 0.327770466237480E-02 0.000000000000000E+00 z1= 2 -.415306922392084E-02 0.000000000000000E+00 z1= 3 -.284242361338817E-02 0.000000000000000E+00 alpha(00001438)=0.000000000000000E+00 beta (00001439)=0.129961888618583E+02 gamma(00001439)=0.129961888618583E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.66210E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1439 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001439)=0.000000000000000E+00 beta (00001440)=0.134615721558988E+02 gamma(00001440)=0.134615721558988E+02 lr_calc_dens: Charge drift due to real space implementation = -0.76397E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1440 z1= 1 -.335398542066317E-02 0.000000000000000E+00 z1= 2 0.475645560219825E-02 0.000000000000000E+00 z1= 3 0.291441968800598E-02 0.000000000000000E+00 alpha(00001440)=0.000000000000000E+00 beta (00001441)=0.130148335350763E+02 gamma(00001441)=0.130148335350763E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.15158E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1441 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001441)=0.000000000000000E+00 beta (00001442)=0.134307114172587E+02 gamma(00001442)=0.134307114172587E+02 lr_calc_dens: Charge drift due to real space implementation = 0.34272E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1442 z1= 1 0.343802331718974E-02 0.000000000000000E+00 z1= 2 -.559379004805858E-02 0.000000000000000E+00 z1= 3 -.300205496443472E-02 0.000000000000000E+00 alpha(00001442)=0.000000000000000E+00 beta (00001443)=0.129833687038856E+02 gamma(00001443)=0.129833687038856E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.56586E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1443 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001443)=0.000000000000000E+00 beta (00001444)=0.134804976659993E+02 gamma(00001444)=0.134804976659993E+02 lr_calc_dens: Charge drift due to real space implementation = 0.42647E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1444 z1= 1 -.350295693593034E-02 0.000000000000000E+00 z1= 2 0.644215633796643E-02 0.000000000000000E+00 z1= 3 0.306661090886809E-02 0.000000000000000E+00 alpha(00001444)=0.000000000000000E+00 beta (00001445)=0.130347284785038E+02 gamma(00001445)=0.130347284785038E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.23964E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1445 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001445)=0.000000000000000E+00 beta (00001446)=0.135058031187438E+02 gamma(00001446)=0.135058031187438E+02 lr_calc_dens: Charge drift due to real space implementation = -0.83010E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1446 z1= 1 0.357513905293921E-02 0.000000000000000E+00 z1= 2 -.716437280659309E-02 0.000000000000000E+00 z1= 3 -.313835604156051E-02 0.000000000000000E+00 alpha(00001446)=0.000000000000000E+00 beta (00001447)=0.129826429003612E+02 gamma(00001447)=0.129826429003612E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.58977E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1447 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001447)=0.000000000000000E+00 beta (00001448)=0.134811912616083E+02 gamma(00001448)=0.134811912616083E+02 lr_calc_dens: Charge drift due to real space implementation = 0.43551E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1448 z1= 1 -.363928252711734E-02 0.000000000000000E+00 z1= 2 0.772489044903727E-02 0.000000000000000E+00 z1= 3 0.320300394051062E-02 0.000000000000000E+00 alpha(00001448)=0.000000000000000E+00 beta (00001449)=0.129561789968657E+02 gamma(00001449)=0.129561789968657E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12041E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1449 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001449)=0.000000000000000E+00 beta (00001450)=0.135361164570381E+02 gamma(00001450)=0.135361164570381E+02 lr_calc_dens: Charge drift due to real space implementation = 0.56309E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1450 z1= 1 0.368366455235456E-02 0.000000000000000E+00 z1= 2 -.812336968171893E-02 0.000000000000000E+00 z1= 3 -.324825438509992E-02 0.000000000000000E+00 alpha(00001450)=0.000000000000000E+00 beta (00001451)=0.129513050186877E+02 gamma(00001451)=0.129513050186877E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.96175E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1451 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001451)=0.000000000000000E+00 beta (00001452)=0.135197862390536E+02 gamma(00001452)=0.135197862390536E+02 lr_calc_dens: Charge drift due to real space implementation = -0.13540E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1452 z1= 1 -.373310959773120E-02 0.000000000000000E+00 z1= 2 0.845586725577768E-02 0.000000000000000E+00 z1= 3 0.330127197284112E-02 0.000000000000000E+00 alpha(00001452)=0.000000000000000E+00 beta (00001453)=0.130222135313911E+02 gamma(00001453)=0.130222135313911E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.20385E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1453 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001453)=0.000000000000000E+00 beta (00001454)=0.135245675834763E+02 gamma(00001454)=0.135245675834763E+02 lr_calc_dens: Charge drift due to real space implementation = 0.86344E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1454 z1= 1 0.380423486090996E-02 0.000000000000000E+00 z1= 2 -.875968584272940E-02 0.000000000000000E+00 z1= 3 -.336765300189050E-02 0.000000000000000E+00 alpha(00001454)=0.000000000000000E+00 beta (00001455)=0.130441596411064E+02 gamma(00001455)=0.130441596411064E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.86616E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1455 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001455)=0.000000000000000E+00 beta (00001456)=0.134707431073170E+02 gamma(00001456)=0.134707431073170E+02 lr_calc_dens: Charge drift due to real space implementation = 0.35570E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1456 z1= 1 -.389030976092425E-02 0.000000000000000E+00 z1= 2 0.894759766932652E-02 0.000000000000000E+00 z1= 3 0.345897509239748E-02 0.000000000000000E+00 alpha(00001456)=0.000000000000000E+00 beta (00001457)=0.130336355771867E+02 gamma(00001457)=0.130336355771867E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.65732E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1457 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001457)=0.000000000000000E+00 beta (00001458)=0.135051019274478E+02 gamma(00001458)=0.135051019274478E+02 lr_calc_dens: Charge drift due to real space implementation = -0.44375E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1458 z1= 1 0.396348481228839E-02 0.000000000000000E+00 z1= 2 -.891034135316349E-02 0.000000000000000E+00 z1= 3 -.353187186106611E-02 0.000000000000000E+00 alpha(00001458)=0.000000000000000E+00 beta (00001459)=0.130142852082733E+02 gamma(00001459)=0.130142852082733E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.47316E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1459 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001459)=0.000000000000000E+00 beta (00001460)=0.134383085319490E+02 gamma(00001460)=0.134383085319490E+02 lr_calc_dens: Charge drift due to real space implementation = 0.60580E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1460 z1= 1 -.404958741281404E-02 0.000000000000000E+00 z1= 2 0.875881561642095E-02 0.000000000000000E+00 z1= 3 0.362554168090854E-02 0.000000000000000E+00 alpha(00001460)=0.000000000000000E+00 beta (00001461)=0.130573169354577E+02 gamma(00001461)=0.130573169354577E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.42739E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1461 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001461)=0.000000000000000E+00 beta (00001462)=0.134459584825691E+02 gamma(00001462)=0.134459584825691E+02 lr_calc_dens: Charge drift due to real space implementation = 0.13472E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1462 z1= 1 0.415027932406432E-02 0.000000000000000E+00 z1= 2 -.857871651917604E-02 0.000000000000000E+00 z1= 3 -.371883366862665E-02 0.000000000000000E+00 alpha(00001462)=0.000000000000000E+00 beta (00001463)=0.129815794454706E+02 gamma(00001463)=0.129815794454706E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.20595E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1463 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001463)=0.000000000000000E+00 beta (00001464)=0.134875127959889E+02 gamma(00001464)=0.134875127959889E+02 lr_calc_dens: Charge drift due to real space implementation = -0.58955E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1464 z1= 1 -.421154969651920E-02 0.000000000000000E+00 z1= 2 0.832864737569580E-02 0.000000000000000E+00 z1= 3 0.378880128077024E-02 0.000000000000000E+00 alpha(00001464)=0.000000000000000E+00 beta (00001465)=0.129797867672270E+02 gamma(00001465)=0.129797867672270E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14972E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1465 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001465)=0.000000000000000E+00 beta (00001466)=0.134814155931881E+02 gamma(00001466)=0.134814155931881E+02 lr_calc_dens: Charge drift due to real space implementation = -0.17616E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1466 z1= 1 0.427845164918862E-02 0.000000000000000E+00 z1= 2 -.820051241765404E-02 0.000000000000000E+00 z1= 3 -.384950051725455E-02 0.000000000000000E+00 alpha(00001466)=0.000000000000000E+00 beta (00001467)=0.130404591997304E+02 gamma(00001467)=0.130404591997304E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.36491E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1467 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001467)=0.000000000000000E+00 beta (00001468)=0.135121335465835E+02 gamma(00001468)=0.135121335465835E+02 lr_calc_dens: Charge drift due to real space implementation = 0.82527E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1468 z1= 1 -.434059703920506E-02 0.000000000000000E+00 z1= 2 0.810837219309798E-02 0.000000000000000E+00 z1= 3 0.393011271210736E-02 0.000000000000000E+00 alpha(00001468)=0.000000000000000E+00 beta (00001469)=0.129821883593486E+02 gamma(00001469)=0.129821883593486E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.69338E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1469 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001469)=0.000000000000000E+00 beta (00001470)=0.135449865663024E+02 gamma(00001470)=0.135449865663024E+02 lr_calc_dens: Charge drift due to real space implementation = 0.34291E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1470 z1= 1 0.438386567943815E-02 0.000000000000000E+00 z1= 2 -.779614056967036E-02 0.000000000000000E+00 z1= 3 -.397119939684078E-02 0.000000000000000E+00 alpha(00001470)=0.000000000000000E+00 beta (00001471)=0.130543777279390E+02 gamma(00001471)=0.130543777279390E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.80427E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1471 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001471)=0.000000000000000E+00 beta (00001472)=0.134940979717453E+02 gamma(00001472)=0.134940979717453E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10548E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1472 z1= 1 -.446005564045364E-02 0.000000000000000E+00 z1= 2 0.747487965140356E-02 0.000000000000000E+00 z1= 3 0.406376593435785E-02 0.000000000000000E+00 alpha(00001472)=0.000000000000000E+00 beta (00001473)=0.130983221785299E+02 gamma(00001473)=0.130983221785299E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.26821E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1473 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001473)=0.000000000000000E+00 beta (00001474)=0.135807360010799E+02 gamma(00001474)=0.135807360010799E+02 lr_calc_dens: Charge drift due to real space implementation = 0.99863E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1474 z1= 1 0.452840024968484E-02 0.000000000000000E+00 z1= 2 -.720986687215726E-02 0.000000000000000E+00 z1= 3 -.412697204896797E-02 0.000000000000000E+00 alpha(00001474)=0.000000000000000E+00 beta (00001475)=0.130080729635300E+02 gamma(00001475)=0.130080729635300E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.93312E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1475 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001475)=0.000000000000000E+00 beta (00001476)=0.135375883261717E+02 gamma(00001476)=0.135375883261717E+02 lr_calc_dens: Charge drift due to real space implementation = 0.50180E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1476 z1= 1 -.457596280163808E-02 0.000000000000000E+00 z1= 2 0.701558219010748E-02 0.000000000000000E+00 z1= 3 0.419204778970779E-02 0.000000000000000E+00 alpha(00001476)=0.000000000000000E+00 beta (00001477)=0.130419115889627E+02 gamma(00001477)=0.130419115889627E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11003E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1477 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001477)=0.000000000000000E+00 beta (00001478)=0.135195353803829E+02 gamma(00001478)=0.135195353803829E+02 lr_calc_dens: Charge drift due to real space implementation = -0.15194E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1478 z1= 1 0.464801155902124E-02 0.000000000000000E+00 z1= 2 -.692234344258856E-02 0.000000000000000E+00 z1= 3 -.426000126353356E-02 0.000000000000000E+00 alpha(00001478)=0.000000000000000E+00 beta (00001479)=0.129652900780508E+02 gamma(00001479)=0.129652900780508E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.42256E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1479 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001479)=0.000000000000000E+00 beta (00001480)=0.134188039362017E+02 gamma(00001480)=0.134188039362017E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12698E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1480 z1= 1 -.472288012618354E-02 0.000000000000000E+00 z1= 2 0.680072284030860E-02 0.000000000000000E+00 z1= 3 0.435107915171543E-02 0.000000000000000E+00 alpha(00001480)=0.000000000000000E+00 beta (00001481)=0.130026190705264E+02 gamma(00001481)=0.130026190705264E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.15001E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1481 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001481)=0.000000000000000E+00 beta (00001482)=0.135356139550869E+02 gamma(00001482)=0.135356139550869E+02 lr_calc_dens: Charge drift due to real space implementation = -0.16049E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1482 z1= 1 0.477198958033032E-02 0.000000000000000E+00 z1= 2 -.658383501097894E-02 0.000000000000000E+00 z1= 3 -.440187563016062E-02 0.000000000000000E+00 alpha(00001482)=0.000000000000000E+00 beta (00001483)=0.130315832539373E+02 gamma(00001483)=0.130315832539373E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.15044E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1483 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001483)=0.000000000000000E+00 beta (00001484)=0.135634036325091E+02 gamma(00001484)=0.135634036325091E+02 lr_calc_dens: Charge drift due to real space implementation = -0.51156E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1484 z1= 1 -.482041868445954E-02 0.000000000000000E+00 z1= 2 0.639463724569709E-02 0.000000000000000E+00 z1= 3 0.446644399830078E-02 0.000000000000000E+00 alpha(00001484)=0.000000000000000E+00 beta (00001485)=0.129566531991893E+02 gamma(00001485)=0.129566531991893E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13301E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1485 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001485)=0.000000000000000E+00 beta (00001486)=0.135712449991136E+02 gamma(00001486)=0.135712449991136E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10387E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1486 z1= 1 0.484022866304253E-02 0.000000000000000E+00 z1= 2 -.624793342177719E-02 0.000000000000000E+00 z1= 3 -.449544476843996E-02 0.000000000000000E+00 alpha(00001486)=0.000000000000000E+00 beta (00001487)=0.129766192461749E+02 gamma(00001487)=0.129766192461749E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.83367E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1487 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001487)=0.000000000000000E+00 beta (00001488)=0.134723478708820E+02 gamma(00001488)=0.134723478708820E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12131E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1488 z1= 1 -.490996881544090E-02 0.000000000000000E+00 z1= 2 0.619488906838007E-02 0.000000000000000E+00 z1= 3 0.457895475876375E-02 0.000000000000000E+00 alpha(00001488)=0.000000000000000E+00 beta (00001489)=0.131189991294658E+02 gamma(00001489)=0.131189991294658E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.21092E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1489 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001489)=0.000000000000000E+00 beta (00001490)=0.135248946339560E+02 gamma(00001490)=0.135248946339560E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10697E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1490 z1= 1 0.500830089902827E-02 0.000000000000000E+00 z1= 2 -.614800381134973E-02 0.000000000000000E+00 z1= 3 -.467930756759515E-02 0.000000000000000E+00 alpha(00001490)=0.000000000000000E+00 beta (00001491)=0.129915554179054E+02 gamma(00001491)=0.129915554179054E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.38290E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1491 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001491)=0.000000000000000E+00 beta (00001492)=0.134814590503207E+02 gamma(00001492)=0.134814590503207E+02 lr_calc_dens: Charge drift due to real space implementation = -0.62763E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1492 z1= 1 -.507808045302483E-02 0.000000000000000E+00 z1= 2 0.619521030547300E-02 0.000000000000000E+00 z1= 3 0.476042172899215E-02 0.000000000000000E+00 alpha(00001492)=0.000000000000000E+00 beta (00001493)=0.130244213351163E+02 gamma(00001493)=0.130244213351163E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.76086E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1493 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001493)=0.000000000000000E+00 beta (00001494)=0.133470709275011E+02 gamma(00001494)=0.133470709275011E+02 lr_calc_dens: Charge drift due to real space implementation = 0.24993E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1494 z1= 1 0.520635293987474E-02 0.000000000000000E+00 z1= 2 -.652004050485301E-02 0.000000000000000E+00 z1= 3 -.489360954212021E-02 0.000000000000000E+00 alpha(00001494)=0.000000000000000E+00 beta (00001495)=0.130624294073084E+02 gamma(00001495)=0.130624294073084E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.96997E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1495 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001495)=0.000000000000000E+00 beta (00001496)=0.134978701357661E+02 gamma(00001496)=0.134978701357661E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11520E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1496 z1= 1 -.529228499935425E-02 0.000000000000000E+00 z1= 2 0.685229489869938E-02 0.000000000000000E+00 z1= 3 0.498802651724700E-02 0.000000000000000E+00 alpha(00001496)=0.000000000000000E+00 beta (00001497)=0.130446980052297E+02 gamma(00001497)=0.130446980052297E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.28193E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1497 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001497)=0.000000000000000E+00 beta (00001498)=0.133892110541089E+02 gamma(00001498)=0.133892110541089E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10330E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1498 z1= 1 0.540604168797757E-02 0.000000000000000E+00 z1= 2 -.710350687105285E-02 0.000000000000000E+00 z1= 3 -.511041544200374E-02 0.000000000000000E+00 alpha(00001498)=0.000000000000000E+00 beta (00001499)=0.129599167174025E+02 gamma(00001499)=0.129599167174025E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.16918E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1499 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001499)=0.000000000000000E+00 beta (00001500)=0.134885773735109E+02 gamma(00001500)=0.134885773735109E+02 lr_calc_dens: Charge drift due to real space implementation = -0.85941E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1500 z1= 1 -.544921607728630E-02 0.000000000000000E+00 z1= 2 0.708840293002932E-02 0.000000000000000E+00 z1= 3 0.516787445162747E-02 0.000000000000000E+00 alpha(00001500)=0.000000000000000E+00 beta (00001501)=0.130564588753881E+02 gamma(00001501)=0.130564588753881E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.94118E-07 lr_apply_liouvillian: applying interaction: normal There are missing files! lanczos restart files can not be found, starting run from scratch Norm of initial Lanczos vectors= 3.241977747413119 Starting Lanczos loop 3 Lanczos iteration: 1 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.42352E-07 lr_apply_liouvillian: applying interaction: normal alpha(00000001)=0.000000000000000E+00 beta (00000002)=0.246163124546712E+01 gamma(00000002)=0.246163124546712E+01 lr_calc_dens: Charge drift due to real space implementation = 0.28582E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 2 z1= 1 0.108504694685410E-06 0.000000000000000E+00 z1= 2 0.229353841116686E-06 0.000000000000000E+00 z1= 3 0.191710225841562E+01 0.000000000000000E+00 alpha(00000002)=0.000000000000000E+00 beta (00000003)=0.795545790350421E+01 gamma(00000003)=0.795545790350421E+01 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.38858E-06 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 3 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000003)=0.000000000000000E+00 beta (00000004)=0.145834628910330E+02 gamma(00000004)=0.145834628910330E+02 lr_calc_dens: Charge drift due to real space implementation = 0.29314E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 4 z1= 1 0.204860953149189E-07 0.000000000000000E+00 z1= 2 -.332261160598175E-06 0.000000000000000E+00 z1= 3 -.759433855604837E+00 0.000000000000000E+00 alpha(00000004)=0.000000000000000E+00 beta (00000005)=0.114620653020346E+02 gamma(00000005)=0.114620653020346E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.45314E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 5 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000005)=0.000000000000000E+00 beta (00000006)=0.148204689647480E+02 gamma(00000006)=0.148204689647480E+02 lr_calc_dens: Charge drift due to real space implementation = -0.18342E-06 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 6 z1= 1 -.493578124266313E-07 0.000000000000000E+00 z1= 2 0.261092207250932E-06 0.000000000000000E+00 z1= 3 0.501298890142831E+00 0.000000000000000E+00 alpha(00000006)=0.000000000000000E+00 beta (00000007)=0.122160445426544E+02 gamma(00000007)=0.122160445426544E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.45174E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 7 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000007)=0.000000000000000E+00 beta (00000008)=0.134339316205258E+02 gamma(00000008)=0.134339316205258E+02 lr_calc_dens: Charge drift due to real space implementation = 0.91271E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 8 z1= 1 0.440212317609132E-07 0.000000000000000E+00 z1= 2 -.149403068675844E-06 0.000000000000000E+00 z1= 3 -.414187034020135E+00 0.000000000000000E+00 alpha(00000008)=0.000000000000000E+00 beta (00000009)=0.134758398836972E+02 gamma(00000009)=0.134758398836972E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.58160E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 9 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000009)=0.000000000000000E+00 beta (00000010)=0.127498485251997E+02 gamma(00000010)=0.127498485251997E+02 lr_calc_dens: Charge drift due to real space implementation = -0.21834E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 10 z1= 1 -.532685693184529E-07 0.000000000000000E+00 z1= 2 0.118086420495941E-06 0.000000000000000E+00 z1= 3 0.420570797909603E+00 0.000000000000000E+00 alpha(00000010)=0.000000000000000E+00 beta (00000011)=0.135625367889400E+02 gamma(00000011)=0.135625367889400E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.39066E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 11 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000011)=0.000000000000000E+00 beta (00000012)=0.130600191541702E+02 gamma(00000012)=0.130600191541702E+02 lr_calc_dens: Charge drift due to real space implementation = -0.36101E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 12 z1= 1 0.607391941148976E-07 0.000000000000000E+00 z1= 2 -.106905577804829E-06 0.000000000000000E+00 z1= 3 -.428734873685518E+00 0.000000000000000E+00 alpha(00000012)=0.000000000000000E+00 beta (00000013)=0.129916844594770E+02 gamma(00000013)=0.129916844594770E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.20846E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 13 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000013)=0.000000000000000E+00 beta (00000014)=0.135340461152209E+02 gamma(00000014)=0.135340461152209E+02 lr_calc_dens: Charge drift due to real space implementation = 0.62627E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 14 z1= 1 -.552584670950136E-07 0.000000000000000E+00 z1= 2 0.137768296763205E-06 0.000000000000000E+00 z1= 3 0.402403753632987E+00 0.000000000000000E+00 alpha(00000014)=0.000000000000000E+00 beta (00000015)=0.126957072494933E+02 gamma(00000015)=0.126957072494933E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.39283E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 15 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000015)=0.000000000000000E+00 beta (00000016)=0.137093874663753E+02 gamma(00000016)=0.137093874663753E+02 lr_calc_dens: Charge drift due to real space implementation = -0.47964E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 16 z1= 1 0.636402146195268E-07 0.000000000000000E+00 z1= 2 -.130514649691803E-06 0.000000000000000E+00 z1= 3 -.358333054087492E+00 0.000000000000000E+00 alpha(00000016)=0.000000000000000E+00 beta (00000017)=0.128223413422518E+02 gamma(00000017)=0.128223413422518E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.62028E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 17 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000017)=0.000000000000000E+00 beta (00000018)=0.135879164565093E+02 gamma(00000018)=0.135879164565093E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10488E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 18 z1= 1 -.686350195721142E-07 0.000000000000000E+00 z1= 2 0.161071267290649E-06 0.000000000000000E+00 z1= 3 0.319129092737873E+00 0.000000000000000E+00 alpha(00000018)=0.000000000000000E+00 beta (00000019)=0.129496423443867E+02 gamma(00000019)=0.129496423443867E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.57511E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 19 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000019)=0.000000000000000E+00 beta (00000020)=0.134023562695904E+02 gamma(00000020)=0.134023562695904E+02 lr_calc_dens: Charge drift due to real space implementation = 0.28634E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 20 z1= 1 0.723515331296822E-07 0.000000000000000E+00 z1= 2 -.143717752567776E-06 0.000000000000000E+00 z1= 3 -.287808949103237E+00 0.000000000000000E+00 alpha(00000020)=0.000000000000000E+00 beta (00000021)=0.130511470708475E+02 gamma(00000021)=0.130511470708475E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.31570E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 21 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000021)=0.000000000000000E+00 beta (00000022)=0.135361386578560E+02 gamma(00000022)=0.135361386578560E+02 lr_calc_dens: Charge drift due to real space implementation = -0.53054E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 22 z1= 1 -.925054902273329E-07 0.000000000000000E+00 z1= 2 0.174608634950321E-06 0.000000000000000E+00 z1= 3 0.259489020479019E+00 0.000000000000000E+00 alpha(00000022)=0.000000000000000E+00 beta (00000023)=0.131036693569678E+02 gamma(00000023)=0.131036693569678E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.15363E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 23 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000023)=0.000000000000000E+00 beta (00000024)=0.135575782587473E+02 gamma(00000024)=0.135575782587473E+02 lr_calc_dens: Charge drift due to real space implementation = 0.55814E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 24 z1= 1 0.867621841317631E-07 0.000000000000000E+00 z1= 2 -.151053109642022E-06 0.000000000000000E+00 z1= 3 -.237061224200742E+00 0.000000000000000E+00 alpha(00000024)=0.000000000000000E+00 beta (00000025)=0.128662200708321E+02 gamma(00000025)=0.128662200708321E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.28231E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 25 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000025)=0.000000000000000E+00 beta (00000026)=0.135577901869629E+02 gamma(00000026)=0.135577901869629E+02 lr_calc_dens: Charge drift due to real space implementation = -0.40559E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 26 z1= 1 -.820307276319061E-07 0.000000000000000E+00 z1= 2 0.156179267787887E-06 0.000000000000000E+00 z1= 3 0.215777288312419E+00 0.000000000000000E+00 alpha(00000026)=0.000000000000000E+00 beta (00000027)=0.129834418896811E+02 gamma(00000027)=0.129834418896811E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.40526E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 27 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000027)=0.000000000000000E+00 beta (00000028)=0.136095602308680E+02 gamma(00000028)=0.136095602308680E+02 lr_calc_dens: Charge drift due to real space implementation = 0.18501E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 28 z1= 1 0.665690196511523E-07 0.000000000000000E+00 z1= 2 -.117741440150344E-06 0.000000000000000E+00 z1= 3 -.200324838746267E+00 0.000000000000000E+00 alpha(00000028)=0.000000000000000E+00 beta (00000029)=0.128862686423598E+02 gamma(00000029)=0.128862686423598E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.38414E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 29 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000029)=0.000000000000000E+00 beta (00000030)=0.134662937804976E+02 gamma(00000030)=0.134662937804976E+02 lr_calc_dens: Charge drift due to real space implementation = 0.82393E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 30 z1= 1 -.378593605721793E-07 0.000000000000000E+00 z1= 2 0.127257879740280E-06 0.000000000000000E+00 z1= 3 0.188352305664184E+00 0.000000000000000E+00 alpha(00000030)=0.000000000000000E+00 beta (00000031)=0.130549024308788E+02 gamma(00000031)=0.130549024308788E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.25961E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 31 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000031)=0.000000000000000E+00 beta (00000032)=0.135828088294106E+02 gamma(00000032)=0.135828088294106E+02 lr_calc_dens: Charge drift due to real space implementation = -0.96485E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 32 z1= 1 0.209256523382306E-07 0.000000000000000E+00 z1= 2 -.115135191312617E-06 0.000000000000000E+00 z1= 3 -.178484502676946E+00 0.000000000000000E+00 alpha(00000032)=0.000000000000000E+00 beta (00000033)=0.129362348048581E+02 gamma(00000033)=0.129362348048581E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13950E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 33 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000033)=0.000000000000000E+00 beta (00000034)=0.135157154879017E+02 gamma(00000034)=0.135157154879017E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10040E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 34 z1= 1 -.446399896151809E-07 0.000000000000000E+00 z1= 2 0.130794727135531E-06 0.000000000000000E+00 z1= 3 0.167975991090068E+00 0.000000000000000E+00 alpha(00000034)=0.000000000000000E+00 beta (00000035)=0.130761194186609E+02 gamma(00000035)=0.130761194186609E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.57559E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 35 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000035)=0.000000000000000E+00 beta (00000036)=0.135398917480947E+02 gamma(00000036)=0.135398917480947E+02 lr_calc_dens: Charge drift due to real space implementation = -0.46750E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 36 z1= 1 0.398961792011404E-07 0.000000000000000E+00 z1= 2 -.132775843827278E-06 0.000000000000000E+00 z1= 3 -.158778732096376E+00 0.000000000000000E+00 alpha(00000036)=0.000000000000000E+00 beta (00000037)=0.129096206524218E+02 gamma(00000037)=0.129096206524218E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.44461E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 37 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000037)=0.000000000000000E+00 beta (00000038)=0.136314157208655E+02 gamma(00000038)=0.136314157208655E+02 lr_calc_dens: Charge drift due to real space implementation = -0.15276E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 38 z1= 1 0.211329123182553E-07 0.000000000000000E+00 z1= 2 0.183062531883245E-06 0.000000000000000E+00 z1= 3 0.146354751303660E+00 0.000000000000000E+00 alpha(00000038)=0.000000000000000E+00 beta (00000039)=0.131004031504731E+02 gamma(00000039)=0.131004031504731E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.81914E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 39 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000039)=0.000000000000000E+00 beta (00000040)=0.134769106255942E+02 gamma(00000040)=0.134769106255942E+02 lr_calc_dens: Charge drift due to real space implementation = 0.51428E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 40 z1= 1 -.450798001186017E-07 0.000000000000000E+00 z1= 2 -.135533429539718E-06 0.000000000000000E+00 z1= 3 -.137934273753397E+00 0.000000000000000E+00 alpha(00000040)=0.000000000000000E+00 beta (00000041)=0.130691730146757E+02 gamma(00000041)=0.130691730146757E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13135E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 41 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000041)=0.000000000000000E+00 beta (00000042)=0.136516469165039E+02 gamma(00000042)=0.136516469165039E+02 lr_calc_dens: Charge drift due to real space implementation = -0.61207E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 42 z1= 1 -.140227782134193E-07 0.000000000000000E+00 z1= 2 0.114425791777051E-06 0.000000000000000E+00 z1= 3 0.128098576527244E+00 0.000000000000000E+00 alpha(00000042)=0.000000000000000E+00 beta (00000043)=0.130102062713310E+02 gamma(00000043)=0.130102062713310E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.17837E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 43 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000043)=0.000000000000000E+00 beta (00000044)=0.135113193186195E+02 gamma(00000044)=0.135113193186195E+02 lr_calc_dens: Charge drift due to real space implementation = 0.54162E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 44 z1= 1 -.123297036618691E-07 0.000000000000000E+00 z1= 2 -.168083048748681E-06 0.000000000000000E+00 z1= 3 -.119948102514589E+00 0.000000000000000E+00 alpha(00000044)=0.000000000000000E+00 beta (00000045)=0.130724541009608E+02 gamma(00000045)=0.130724541009608E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.21348E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 45 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000045)=0.000000000000000E+00 beta (00000046)=0.133577452521303E+02 gamma(00000046)=0.133577452521303E+02 lr_calc_dens: Charge drift due to real space implementation = -0.35311E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 46 z1= 1 0.135128413824922E-06 0.000000000000000E+00 z1= 2 0.148762638596609E-06 0.000000000000000E+00 z1= 3 0.114649558570429E+00 0.000000000000000E+00 alpha(00000046)=0.000000000000000E+00 beta (00000047)=0.130255247232302E+02 gamma(00000047)=0.130255247232302E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.22901E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 47 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000047)=0.000000000000000E+00 beta (00000048)=0.135435793207965E+02 gamma(00000048)=0.135435793207965E+02 lr_calc_dens: Charge drift due to real space implementation = 0.91739E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 48 z1= 1 -.149013336731520E-06 0.000000000000000E+00 z1= 2 -.132968872155611E-06 0.000000000000000E+00 z1= 3 -.108479401780228E+00 0.000000000000000E+00 alpha(00000048)=0.000000000000000E+00 beta (00000049)=0.128690484147158E+02 gamma(00000049)=0.128690484147158E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.23340E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 49 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000049)=0.000000000000000E+00 beta (00000050)=0.134599982607547E+02 gamma(00000050)=0.134599982607547E+02 lr_calc_dens: Charge drift due to real space implementation = 0.67635E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 50 z1= 1 0.925321658398505E-07 0.000000000000000E+00 z1= 2 0.102168705785858E-06 0.000000000000000E+00 z1= 3 0.102667708836132E+00 0.000000000000000E+00 alpha(00000050)=0.000000000000000E+00 beta (00000051)=0.131327856015406E+02 gamma(00000051)=0.131327856015406E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.23783E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 51 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000051)=0.000000000000000E+00 beta (00000052)=0.134085971698488E+02 gamma(00000052)=0.134085971698488E+02 lr_calc_dens: Charge drift due to real space implementation = -0.24368E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 52 z1= 1 -.777345776977267E-07 0.000000000000000E+00 z1= 2 -.116131941352017E-06 0.000000000000000E+00 z1= 3 -.998828054860804E-01 0.000000000000000E+00 alpha(00000052)=0.000000000000000E+00 beta (00000053)=0.131042005795281E+02 gamma(00000053)=0.131042005795281E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.23819E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 53 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000053)=0.000000000000000E+00 beta (00000054)=0.134021478196802E+02 gamma(00000054)=0.134021478196802E+02 lr_calc_dens: Charge drift due to real space implementation = 0.44850E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 54 z1= 1 0.485297357814876E-07 0.000000000000000E+00 z1= 2 0.212295671201465E-06 0.000000000000000E+00 z1= 3 0.972020099255759E-01 0.000000000000000E+00 alpha(00000054)=0.000000000000000E+00 beta (00000055)=0.129811508266621E+02 gamma(00000055)=0.129811508266621E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.23478E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 55 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000055)=0.000000000000000E+00 beta (00000056)=0.135556269122355E+02 gamma(00000056)=0.135556269122355E+02 lr_calc_dens: Charge drift due to real space implementation = -0.63431E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 56 z1= 1 -.469133326905591E-07 0.000000000000000E+00 z1= 2 -.253108851618838E-06 0.000000000000000E+00 z1= 3 -.928095975782813E-01 0.000000000000000E+00 alpha(00000056)=0.000000000000000E+00 beta (00000057)=0.129840879042549E+02 gamma(00000057)=0.129840879042549E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.23391E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 57 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000057)=0.000000000000000E+00 beta (00000058)=0.134563592194494E+02 gamma(00000058)=0.134563592194494E+02 lr_calc_dens: Charge drift due to real space implementation = 0.78647E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 58 z1= 1 0.101843919026631E-06 0.000000000000000E+00 z1= 2 0.225610913277454E-06 0.000000000000000E+00 z1= 3 0.893018113110912E-01 0.000000000000000E+00 alpha(00000058)=0.000000000000000E+00 beta (00000059)=0.130347624206714E+02 gamma(00000059)=0.130347624206714E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.22424E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 59 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000059)=0.000000000000000E+00 beta (00000060)=0.132763111501833E+02 gamma(00000060)=0.132763111501833E+02 lr_calc_dens: Charge drift due to real space implementation = -0.74412E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 60 z1= 1 -.172109149793304E-06 0.000000000000000E+00 z1= 2 -.183101302037043E-06 0.000000000000000E+00 z1= 3 -.872462192087783E-01 0.000000000000000E+00 alpha(00000060)=0.000000000000000E+00 beta (00000061)=0.131692644707684E+02 gamma(00000061)=0.131692644707684E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.22461E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 61 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000061)=0.000000000000000E+00 beta (00000062)=0.134137746749233E+02 gamma(00000062)=0.134137746749233E+02 lr_calc_dens: Charge drift due to real space implementation = 0.77489E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 62 z1= 1 0.278822744972700E-06 0.000000000000000E+00 z1= 2 0.723391858593387E-07 0.000000000000000E+00 z1= 3 0.852430936064425E-01 0.000000000000000E+00 alpha(00000062)=0.000000000000000E+00 beta (00000063)=0.130309950715345E+02 gamma(00000063)=0.130309950715345E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.23456E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 63 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000063)=0.000000000000000E+00 beta (00000064)=0.135322883005493E+02 gamma(00000064)=0.135322883005493E+02 lr_calc_dens: Charge drift due to real space implementation = -0.94235E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 64 z1= 1 -.182224516142811E-06 0.000000000000000E+00 z1= 2 -.105904196403539E-06 0.000000000000000E+00 z1= 3 -.819120372353787E-01 0.000000000000000E+00 alpha(00000064)=0.000000000000000E+00 beta (00000065)=0.130028219899240E+02 gamma(00000065)=0.130028219899240E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.23646E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 65 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000065)=0.000000000000000E+00 beta (00000066)=0.134504794835087E+02 gamma(00000066)=0.134504794835087E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10728E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 66 z1= 1 -.144188117600870E-06 0.000000000000000E+00 z1= 2 0.149158724015707E-06 0.000000000000000E+00 z1= 3 0.792461540571625E-01 0.000000000000000E+00 alpha(00000066)=0.000000000000000E+00 beta (00000067)=0.129988562214826E+02 gamma(00000067)=0.129988562214826E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.22926E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 67 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000067)=0.000000000000000E+00 beta (00000068)=0.135720953305370E+02 gamma(00000068)=0.135720953305370E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10061E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 68 z1= 1 0.411266867437358E-06 0.000000000000000E+00 z1= 2 -.321270096953103E-06 0.000000000000000E+00 z1= 3 -.760099401255797E-01 0.000000000000000E+00 alpha(00000068)=0.000000000000000E+00 beta (00000069)=0.130949694063023E+02 gamma(00000069)=0.130949694063023E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.23355E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 69 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000069)=0.000000000000000E+00 beta (00000070)=0.133875401274082E+02 gamma(00000070)=0.133875401274082E+02 lr_calc_dens: Charge drift due to real space implementation = 0.97043E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 70 z1= 1 -.423045693642587E-06 0.000000000000000E+00 z1= 2 0.455929548499356E-06 0.000000000000000E+00 z1= 3 0.744918668625541E-01 0.000000000000000E+00 alpha(00000070)=0.000000000000000E+00 beta (00000071)=0.131533887436359E+02 gamma(00000071)=0.131533887436359E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.24985E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 71 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000071)=0.000000000000000E+00 beta (00000072)=0.133302605357199E+02 gamma(00000072)=0.133302605357199E+02 lr_calc_dens: Charge drift due to real space implementation = -0.13071E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 72 z1= 1 0.259526436935239E-06 0.000000000000000E+00 z1= 2 -.529202824745782E-06 0.000000000000000E+00 z1= 3 -.739088461057850E-01 0.000000000000000E+00 alpha(00000072)=0.000000000000000E+00 beta (00000073)=0.130686804828506E+02 gamma(00000073)=0.130686804828506E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.24487E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 73 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000073)=0.000000000000000E+00 beta (00000074)=0.133400255484383E+02 gamma(00000074)=0.133400255484383E+02 lr_calc_dens: Charge drift due to real space implementation = 0.16837E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 74 z1= 1 0.274352237292347E-07 0.000000000000000E+00 z1= 2 0.312144934319290E-06 0.000000000000000E+00 z1= 3 0.730887279000202E-01 0.000000000000000E+00 alpha(00000074)=0.000000000000000E+00 beta (00000075)=0.130083398607825E+02 gamma(00000075)=0.130083398607825E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.21910E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 75 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000075)=0.000000000000000E+00 beta (00000076)=0.135512847795081E+02 gamma(00000076)=0.135512847795081E+02 lr_calc_dens: Charge drift due to real space implementation = -0.18265E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 76 z1= 1 -.343923041245085E-06 0.000000000000000E+00 z1= 2 -.148495549284944E-06 0.000000000000000E+00 z1= 3 -.709027767172972E-01 0.000000000000000E+00 alpha(00000076)=0.000000000000000E+00 beta (00000077)=0.129930509650877E+02 gamma(00000077)=0.129930509650877E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.18254E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 77 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000077)=0.000000000000000E+00 beta (00000078)=0.135518842590571E+02 gamma(00000078)=0.135518842590571E+02 lr_calc_dens: Charge drift due to real space implementation = 0.15331E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 78 z1= 1 0.451368974921511E-06 0.000000000000000E+00 z1= 2 -.550722583961582E-07 0.000000000000000E+00 z1= 3 0.684710579614418E-01 0.000000000000000E+00 alpha(00000078)=0.000000000000000E+00 beta (00000079)=0.129508396693937E+02 gamma(00000079)=0.129508396693937E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.17529E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 79 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000079)=0.000000000000000E+00 beta (00000080)=0.134845024733767E+02 gamma(00000080)=0.134845024733767E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12234E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 80 z1= 1 -.212544841470256E-06 0.000000000000000E+00 z1= 2 0.999400848673671E-07 0.000000000000000E+00 z1= 3 -.660070661971779E-01 0.000000000000000E+00 alpha(00000080)=0.000000000000000E+00 beta (00000081)=0.129933373081142E+02 gamma(00000081)=0.129933373081142E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.20021E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 81 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000081)=0.000000000000000E+00 beta (00000082)=0.135376075777407E+02 gamma(00000082)=0.135376075777407E+02 lr_calc_dens: Charge drift due to real space implementation = 0.13690E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 82 z1= 1 -.137914928608057E-06 0.000000000000000E+00 z1= 2 -.156086651684694E-06 0.000000000000000E+00 z1= 3 0.637266556277671E-01 0.000000000000000E+00 alpha(00000082)=0.000000000000000E+00 beta (00000083)=0.130317036300764E+02 gamma(00000083)=0.130317036300764E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.21762E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 83 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000083)=0.000000000000000E+00 beta (00000084)=0.134529057793830E+02 gamma(00000084)=0.134529057793830E+02 lr_calc_dens: Charge drift due to real space implementation = -0.17768E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 84 z1= 1 0.443677526536624E-06 0.000000000000000E+00 z1= 2 0.144089982042279E-06 0.000000000000000E+00 z1= 3 -.623969306986239E-01 0.000000000000000E+00 alpha(00000084)=0.000000000000000E+00 beta (00000085)=0.130961704657766E+02 gamma(00000085)=0.130961704657766E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.21224E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 85 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000085)=0.000000000000000E+00 beta (00000086)=0.133737482635113E+02 gamma(00000086)=0.133737482635113E+02 lr_calc_dens: Charge drift due to real space implementation = 0.21664E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 86 z1= 1 -.625841474817833E-06 0.000000000000000E+00 z1= 2 -.190375468878451E-06 0.000000000000000E+00 z1= 3 0.618697113395608E-01 0.000000000000000E+00 alpha(00000086)=0.000000000000000E+00 beta (00000087)=0.131327236779145E+02 gamma(00000087)=0.131327236779145E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.17852E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 87 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000087)=0.000000000000000E+00 beta (00000088)=0.135232006835804E+02 gamma(00000088)=0.135232006835804E+02 lr_calc_dens: Charge drift due to real space implementation = -0.22228E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 88 z1= 1 0.704367096445715E-06 0.000000000000000E+00 z1= 2 0.112667635202315E-06 0.000000000000000E+00 z1= 3 -.606900350930900E-01 0.000000000000000E+00 alpha(00000088)=0.000000000000000E+00 beta (00000089)=0.131629775968419E+02 gamma(00000089)=0.131629775968419E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13847E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 89 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000089)=0.000000000000000E+00 beta (00000090)=0.135580802202015E+02 gamma(00000090)=0.135580802202015E+02 lr_calc_dens: Charge drift due to real space implementation = 0.19384E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 90 z1= 1 -.624218296460500E-06 0.000000000000000E+00 z1= 2 0.417776563747963E-07 0.000000000000000E+00 z1= 3 0.591083072202114E-01 0.000000000000000E+00 alpha(00000090)=0.000000000000000E+00 beta (00000091)=0.130188494580332E+02 gamma(00000091)=0.130188494580332E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12477E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 91 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000091)=0.000000000000000E+00 beta (00000092)=0.134698128945797E+02 gamma(00000092)=0.134698128945797E+02 lr_calc_dens: Charge drift due to real space implementation = -0.17100E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 92 z1= 1 0.284360297297903E-06 0.000000000000000E+00 z1= 2 -.516745235481640E-06 0.000000000000000E+00 z1= 3 -.569034025401170E-01 0.000000000000000E+00 alpha(00000092)=0.000000000000000E+00 beta (00000093)=0.129128409544406E+02 gamma(00000093)=0.129128409544406E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12400E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 93 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000093)=0.000000000000000E+00 beta (00000094)=0.135393229356169E+02 gamma(00000094)=0.135393229356169E+02 lr_calc_dens: Charge drift due to real space implementation = 0.17650E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 94 z1= 1 0.116841250186232E-06 0.000000000000000E+00 z1= 2 0.945921848813390E-06 0.000000000000000E+00 z1= 3 0.540470552766091E-01 0.000000000000000E+00 alpha(00000094)=0.000000000000000E+00 beta (00000095)=0.128966766666914E+02 gamma(00000095)=0.128966766666914E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10098E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 95 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000095)=0.000000000000000E+00 beta (00000096)=0.134977585582955E+02 gamma(00000096)=0.134977585582955E+02 lr_calc_dens: Charge drift due to real space implementation = -0.17318E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 96 z1= 1 -.477886106126713E-06 0.000000000000000E+00 z1= 2 -.111804907886699E-05 0.000000000000000E+00 z1= 3 -.516902027225652E-01 0.000000000000000E+00 alpha(00000096)=0.000000000000000E+00 beta (00000097)=0.130173524242202E+02 gamma(00000097)=0.130173524242202E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.84180E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 97 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000097)=0.000000000000000E+00 beta (00000098)=0.135051870814639E+02 gamma(00000098)=0.135051870814639E+02 lr_calc_dens: Charge drift due to real space implementation = 0.16010E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 98 z1= 1 0.666907785961026E-06 0.000000000000000E+00 z1= 2 0.113999107253190E-05 0.000000000000000E+00 z1= 3 0.501751137876932E-01 0.000000000000000E+00 alpha(00000098)=0.000000000000000E+00 beta (00000099)=0.128435522200296E+02 gamma(00000099)=0.128435522200296E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.99500E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 99 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000099)=0.000000000000000E+00 beta (00000100)=0.134822316908235E+02 gamma(00000100)=0.134822316908235E+02 lr_calc_dens: Charge drift due to real space implementation = -0.16128E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 100 z1= 1 -.645039489235262E-06 0.000000000000000E+00 z1= 2 -.992726325299502E-06 0.000000000000000E+00 z1= 3 -.484031757226999E-01 0.000000000000000E+00 alpha(00000100)=0.000000000000000E+00 beta (00000101)=0.129962211584053E+02 gamma(00000101)=0.129962211584053E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.11946E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 101 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000101)=0.000000000000000E+00 beta (00000102)=0.136121667663508E+02 gamma(00000102)=0.136121667663508E+02 lr_calc_dens: Charge drift due to real space implementation = 0.19041E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 102 z1= 1 0.449973977459509E-06 0.000000000000000E+00 z1= 2 0.510340617640744E-06 0.000000000000000E+00 z1= 3 0.468858194399689E-01 0.000000000000000E+00 alpha(00000102)=0.000000000000000E+00 beta (00000103)=0.130035079065302E+02 gamma(00000103)=0.130035079065302E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.99009E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 103 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000103)=0.000000000000000E+00 beta (00000104)=0.134692176765068E+02 gamma(00000104)=0.134692176765068E+02 lr_calc_dens: Charge drift due to real space implementation = -0.20065E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 104 z1= 1 -.776261305457916E-08 0.000000000000000E+00 z1= 2 0.125775204089982E-06 0.000000000000000E+00 z1= 3 -.456869472223550E-01 0.000000000000000E+00 alpha(00000104)=0.000000000000000E+00 beta (00000105)=0.130451357175884E+02 gamma(00000105)=0.130451357175884E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.64141E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 105 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000105)=0.000000000000000E+00 beta (00000106)=0.134480722748681E+02 gamma(00000106)=0.134480722748681E+02 lr_calc_dens: Charge drift due to real space implementation = 0.19002E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 106 z1= 1 -.436031137096546E-06 0.000000000000000E+00 z1= 2 -.986749316065044E-06 0.000000000000000E+00 z1= 3 0.442961941215863E-01 0.000000000000000E+00 alpha(00000106)=0.000000000000000E+00 beta (00000107)=0.129765950959204E+02 gamma(00000107)=0.129765950959204E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.43563E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 107 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000107)=0.000000000000000E+00 beta (00000108)=0.134938014121609E+02 gamma(00000108)=0.134938014121609E+02 lr_calc_dens: Charge drift due to real space implementation = -0.19132E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 108 z1= 1 0.800760246228812E-06 0.000000000000000E+00 z1= 2 0.187939736231279E-05 0.000000000000000E+00 z1= 3 -.422176053673130E-01 0.000000000000000E+00 alpha(00000108)=0.000000000000000E+00 beta (00000109)=0.129794008155166E+02 gamma(00000109)=0.129794008155166E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10338E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 109 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000109)=0.000000000000000E+00 beta (00000110)=0.134060684965478E+02 gamma(00000110)=0.134060684965478E+02 lr_calc_dens: Charge drift due to real space implementation = 0.19292E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 110 z1= 1 -.114872328960389E-05 0.000000000000000E+00 z1= 2 -.257033880400612E-05 0.000000000000000E+00 z1= 3 0.402313814528183E-01 0.000000000000000E+00 alpha(00000110)=0.000000000000000E+00 beta (00000111)=0.131144188488960E+02 gamma(00000111)=0.131144188488960E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.43389E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 111 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000111)=0.000000000000000E+00 beta (00000112)=0.134786285078415E+02 gamma(00000112)=0.134786285078415E+02 lr_calc_dens: Charge drift due to real space implementation = -0.15129E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 112 z1= 1 0.107681455052108E-05 0.000000000000000E+00 z1= 2 0.302029374073429E-05 0.000000000000000E+00 z1= 3 -.383011646186984E-01 0.000000000000000E+00 alpha(00000112)=0.000000000000000E+00 beta (00000113)=0.130273700091995E+02 gamma(00000113)=0.130273700091995E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.63840E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 113 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000113)=0.000000000000000E+00 beta (00000114)=0.134498652322079E+02 gamma(00000114)=0.134498652322079E+02 lr_calc_dens: Charge drift due to real space implementation = 0.89633E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 114 z1= 1 -.472199241729488E-06 0.000000000000000E+00 z1= 2 -.319685500808414E-05 0.000000000000000E+00 z1= 3 0.361980595732573E-01 0.000000000000000E+00 alpha(00000114)=0.000000000000000E+00 beta (00000115)=0.130375168710761E+02 gamma(00000115)=0.130375168710761E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.27847E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 115 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000115)=0.000000000000000E+00 beta (00000116)=0.135114228638932E+02 gamma(00000116)=0.135114228638932E+02 lr_calc_dens: Charge drift due to real space implementation = -0.79445E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 116 z1= 1 -.563357464131837E-06 0.000000000000000E+00 z1= 2 0.274324439931276E-05 0.000000000000000E+00 z1= 3 -.344284391926962E-01 0.000000000000000E+00 alpha(00000116)=0.000000000000000E+00 beta (00000117)=0.130240942266337E+02 gamma(00000117)=0.130240942266337E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.35893E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 117 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000117)=0.000000000000000E+00 beta (00000118)=0.135885528027148E+02 gamma(00000118)=0.135885528027148E+02 lr_calc_dens: Charge drift due to real space implementation = 0.89098E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 118 z1= 1 0.182439382238656E-05 0.000000000000000E+00 z1= 2 -.219436885273739E-05 0.000000000000000E+00 z1= 3 0.329639973904378E-01 0.000000000000000E+00 alpha(00000118)=0.000000000000000E+00 beta (00000119)=0.131904606338438E+02 gamma(00000119)=0.131904606338438E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.96325E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 119 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000119)=0.000000000000000E+00 beta (00000120)=0.133816939238600E+02 gamma(00000120)=0.133816939238600E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11718E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 120 z1= 1 -.331191324236485E-05 0.000000000000000E+00 z1= 2 0.163773092705403E-05 0.000000000000000E+00 z1= 3 -.326798512473579E-01 0.000000000000000E+00 alpha(00000120)=0.000000000000000E+00 beta (00000121)=0.130861090810107E+02 gamma(00000121)=0.130861090810107E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.65085E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 121 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000121)=0.000000000000000E+00 beta (00000122)=0.134490396826708E+02 gamma(00000122)=0.134490396826708E+02 lr_calc_dens: Charge drift due to real space implementation = 0.15982E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 122 z1= 1 0.466652733688933E-05 0.000000000000000E+00 z1= 2 -.910987101019978E-06 0.000000000000000E+00 z1= 3 0.321071042305846E-01 0.000000000000000E+00 alpha(00000122)=0.000000000000000E+00 beta (00000123)=0.129966511642412E+02 gamma(00000123)=0.129966511642412E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.34641E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 123 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000123)=0.000000000000000E+00 beta (00000124)=0.136090631373565E+02 gamma(00000124)=0.136090631373565E+02 lr_calc_dens: Charge drift due to real space implementation = -0.18452E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 124 z1= 1 -.569059593317724E-05 0.000000000000000E+00 z1= 2 -.150635459690737E-08 0.000000000000000E+00 z1= 3 -.308026708774242E-01 0.000000000000000E+00 alpha(00000124)=0.000000000000000E+00 beta (00000125)=0.129100214981175E+02 gamma(00000125)=0.129100214981175E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11239E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 125 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000125)=0.000000000000000E+00 beta (00000126)=0.134708213995697E+02 gamma(00000126)=0.134708213995697E+02 lr_calc_dens: Charge drift due to real space implementation = 0.15154E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 126 z1= 1 0.655264443750120E-05 0.000000000000000E+00 z1= 2 0.667811545573232E-06 0.000000000000000E+00 z1= 3 0.291084867114042E-01 0.000000000000000E+00 alpha(00000126)=0.000000000000000E+00 beta (00000127)=0.130914241699292E+02 gamma(00000127)=0.130914241699292E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.16544E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 127 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000127)=0.000000000000000E+00 beta (00000128)=0.134549739511094E+02 gamma(00000128)=0.134549739511094E+02 lr_calc_dens: Charge drift due to real space implementation = -0.78583E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 128 z1= 1 -.698065016780422E-05 0.000000000000000E+00 z1= 2 -.128291138113148E-05 0.000000000000000E+00 z1= 3 -.273215870526771E-01 0.000000000000000E+00 alpha(00000128)=0.000000000000000E+00 beta (00000129)=0.130330938865232E+02 gamma(00000129)=0.130330938865232E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.14931E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 129 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000129)=0.000000000000000E+00 beta (00000130)=0.134206922149808E+02 gamma(00000130)=0.134206922149808E+02 lr_calc_dens: Charge drift due to real space implementation = 0.36115E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 130 z1= 1 0.692771806008802E-05 0.000000000000000E+00 z1= 2 0.158862967796848E-05 0.000000000000000E+00 z1= 3 0.252352529848471E-01 0.000000000000000E+00 alpha(00000130)=0.000000000000000E+00 beta (00000131)=0.131878393034062E+02 gamma(00000131)=0.131878393034062E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10394E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 131 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000131)=0.000000000000000E+00 beta (00000132)=0.133963225297932E+02 gamma(00000132)=0.133963225297932E+02 lr_calc_dens: Charge drift due to real space implementation = -0.48560E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 132 z1= 1 -.689685562763584E-05 0.000000000000000E+00 z1= 2 -.194608791886627E-05 0.000000000000000E+00 z1= 3 -.235248658121501E-01 0.000000000000000E+00 alpha(00000132)=0.000000000000000E+00 beta (00000133)=0.130924907077393E+02 gamma(00000133)=0.130924907077393E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10347E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 133 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000133)=0.000000000000000E+00 beta (00000134)=0.135969157735817E+02 gamma(00000134)=0.135969157735817E+02 lr_calc_dens: Charge drift due to real space implementation = 0.55363E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 134 z1= 1 0.636992555004934E-05 0.000000000000000E+00 z1= 2 0.200386480771939E-05 0.000000000000000E+00 z1= 3 0.214583889595006E-01 0.000000000000000E+00 alpha(00000134)=0.000000000000000E+00 beta (00000135)=0.129809819848608E+02 gamma(00000135)=0.129809819848608E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14254E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 135 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000135)=0.000000000000000E+00 beta (00000136)=0.134272509873020E+02 gamma(00000136)=0.134272509873020E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12913E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 136 z1= 1 -.529605542431547E-05 0.000000000000000E+00 z1= 2 -.215455607059143E-05 0.000000000000000E+00 z1= 3 -.196868173019616E-01 0.000000000000000E+00 alpha(00000136)=0.000000000000000E+00 beta (00000137)=0.132213588198732E+02 gamma(00000137)=0.132213588198732E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.14317E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 137 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000137)=0.000000000000000E+00 beta (00000138)=0.133890100833872E+02 gamma(00000138)=0.133890100833872E+02 lr_calc_dens: Charge drift due to real space implementation = -0.28643E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 138 z1= 1 0.386333620477437E-05 0.000000000000000E+00 z1= 2 0.208232076820602E-05 0.000000000000000E+00 z1= 3 0.187431680517446E-01 0.000000000000000E+00 alpha(00000138)=0.000000000000000E+00 beta (00000139)=0.131119904438510E+02 gamma(00000139)=0.131119904438510E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.98192E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 139 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000139)=0.000000000000000E+00 beta (00000140)=0.134016086570357E+02 gamma(00000140)=0.134016086570357E+02 lr_calc_dens: Charge drift due to real space implementation = 0.93223E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 140 z1= 1 -.220609061399076E-05 0.000000000000000E+00 z1= 2 -.191925211375286E-05 0.000000000000000E+00 z1= 3 -.181220795810684E-01 0.000000000000000E+00 alpha(00000140)=0.000000000000000E+00 beta (00000141)=0.131328372582679E+02 gamma(00000141)=0.131328372582679E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.63873E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 141 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000141)=0.000000000000000E+00 beta (00000142)=0.133782650898189E+02 gamma(00000142)=0.133782650898189E+02 lr_calc_dens: Charge drift due to real space implementation = 0.70012E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 142 z1= 1 0.495574922575319E-06 0.000000000000000E+00 z1= 2 0.120730350954799E-05 0.000000000000000E+00 z1= 3 0.178694256096682E-01 0.000000000000000E+00 alpha(00000142)=0.000000000000000E+00 beta (00000143)=0.131655464526687E+02 gamma(00000143)=0.131655464526687E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.11293E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 143 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000143)=0.000000000000000E+00 beta (00000144)=0.133232295971476E+02 gamma(00000144)=0.133232295971476E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11270E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 144 z1= 1 0.121290883639062E-05 0.000000000000000E+00 z1= 2 -.461296743790491E-06 0.000000000000000E+00 z1= 3 -.176132312680069E-01 0.000000000000000E+00 alpha(00000144)=0.000000000000000E+00 beta (00000145)=0.130800465015751E+02 gamma(00000145)=0.130800465015751E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.20463E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 145 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000145)=0.000000000000000E+00 beta (00000146)=0.134303815323568E+02 gamma(00000146)=0.134303815323568E+02 lr_calc_dens: Charge drift due to real space implementation = 0.64805E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 146 z1= 1 -.300259258889215E-05 0.000000000000000E+00 z1= 2 -.483531915072398E-06 0.000000000000000E+00 z1= 3 0.164984036972526E-01 0.000000000000000E+00 alpha(00000146)=0.000000000000000E+00 beta (00000147)=0.130718863940834E+02 gamma(00000147)=0.130718863940834E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.25084E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 147 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000147)=0.000000000000000E+00 beta (00000148)=0.135003778724132E+02 gamma(00000148)=0.135003778724132E+02 lr_calc_dens: Charge drift due to real space implementation = 0.26224E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 148 z1= 1 0.478771201468117E-05 0.000000000000000E+00 z1= 2 0.137114420667792E-05 0.000000000000000E+00 z1= 3 -.148178643435176E-01 0.000000000000000E+00 alpha(00000148)=0.000000000000000E+00 beta (00000149)=0.130542795085756E+02 gamma(00000149)=0.130542795085756E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.22196E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 149 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000149)=0.000000000000000E+00 beta (00000150)=0.133468176105119E+02 gamma(00000150)=0.133468176105119E+02 lr_calc_dens: Charge drift due to real space implementation = -0.81852E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 150 z1= 1 -.619444269708155E-05 0.000000000000000E+00 z1= 2 -.187742242840494E-05 0.000000000000000E+00 z1= 3 0.131688502263284E-01 0.000000000000000E+00 alpha(00000150)=0.000000000000000E+00 beta (00000151)=0.131294177826277E+02 gamma(00000151)=0.131294177826277E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.16599E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 151 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000151)=0.000000000000000E+00 beta (00000152)=0.134264344904704E+02 gamma(00000152)=0.134264344904704E+02 lr_calc_dens: Charge drift due to real space implementation = 0.90811E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 152 z1= 1 0.716305233250526E-05 0.000000000000000E+00 z1= 2 0.216308173660667E-05 0.000000000000000E+00 z1= 3 -.117008372738667E-01 0.000000000000000E+00 alpha(00000152)=0.000000000000000E+00 beta (00000153)=0.131614488080959E+02 gamma(00000153)=0.131614488080959E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12414E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 153 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000153)=0.000000000000000E+00 beta (00000154)=0.134143135474759E+02 gamma(00000154)=0.134143135474759E+02 lr_calc_dens: Charge drift due to real space implementation = -0.67030E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 154 z1= 1 -.787684378486617E-05 0.000000000000000E+00 z1= 2 -.245707761723815E-05 0.000000000000000E+00 z1= 3 0.105963563621822E-01 0.000000000000000E+00 alpha(00000154)=0.000000000000000E+00 beta (00000155)=0.131832360574084E+02 gamma(00000155)=0.131832360574084E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.11740E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 155 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000155)=0.000000000000000E+00 beta (00000156)=0.133697610246565E+02 gamma(00000156)=0.133697610246565E+02 lr_calc_dens: Charge drift due to real space implementation = 0.49127E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 156 z1= 1 0.851617119584670E-05 0.000000000000000E+00 z1= 2 0.285627532347856E-05 0.000000000000000E+00 z1= 3 -.981468022114447E-02 0.000000000000000E+00 alpha(00000156)=0.000000000000000E+00 beta (00000157)=0.132166573018835E+02 gamma(00000157)=0.132166573018835E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12751E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 157 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000157)=0.000000000000000E+00 beta (00000158)=0.134656747107086E+02 gamma(00000158)=0.134656747107086E+02 lr_calc_dens: Charge drift due to real space implementation = -0.52386E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 158 z1= 1 -.903898940889964E-05 0.000000000000000E+00 z1= 2 -.310330422363480E-05 0.000000000000000E+00 z1= 3 0.919906788048867E-02 0.000000000000000E+00 alpha(00000158)=0.000000000000000E+00 beta (00000159)=0.131356695497787E+02 gamma(00000159)=0.131356695497787E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12824E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 159 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000159)=0.000000000000000E+00 beta (00000160)=0.133866013578177E+02 gamma(00000160)=0.133866013578177E+02 lr_calc_dens: Charge drift due to real space implementation = 0.54790E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 160 z1= 1 0.913665950016324E-05 0.000000000000000E+00 z1= 2 0.324195853323074E-05 0.000000000000000E+00 z1= 3 -.872464381856204E-02 0.000000000000000E+00 alpha(00000160)=0.000000000000000E+00 beta (00000161)=0.129867051873466E+02 gamma(00000161)=0.129867051873466E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12934E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 161 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000161)=0.000000000000000E+00 beta (00000162)=0.133774677685480E+02 gamma(00000162)=0.133774677685480E+02 lr_calc_dens: Charge drift due to real space implementation = -0.51255E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 162 z1= 1 -.848366307479762E-05 0.000000000000000E+00 z1= 2 -.316218107990493E-05 0.000000000000000E+00 z1= 3 0.831225070533475E-02 0.000000000000000E+00 alpha(00000162)=0.000000000000000E+00 beta (00000163)=0.129521951650414E+02 gamma(00000163)=0.129521951650414E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13423E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 163 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000163)=0.000000000000000E+00 beta (00000164)=0.134728738831217E+02 gamma(00000164)=0.134728738831217E+02 lr_calc_dens: Charge drift due to real space implementation = 0.34926E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 164 z1= 1 0.719595240821423E-05 0.000000000000000E+00 z1= 2 0.318883898836956E-05 0.000000000000000E+00 z1= 3 -.775008942899505E-02 0.000000000000000E+00 alpha(00000164)=0.000000000000000E+00 beta (00000165)=0.130056087421614E+02 gamma(00000165)=0.130056087421614E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.16978E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 165 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000165)=0.000000000000000E+00 beta (00000166)=0.134293948089538E+02 gamma(00000166)=0.134293948089538E+02 lr_calc_dens: Charge drift due to real space implementation = -0.55308E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 166 z1= 1 -.540712077553044E-05 0.000000000000000E+00 z1= 2 -.341496848075254E-05 0.000000000000000E+00 z1= 3 0.691428111364210E-02 0.000000000000000E+00 alpha(00000166)=0.000000000000000E+00 beta (00000167)=0.129900323914114E+02 gamma(00000167)=0.129900323914114E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.19423E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 167 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000167)=0.000000000000000E+00 beta (00000168)=0.133639467781516E+02 gamma(00000168)=0.133639467781516E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10726E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 168 z1= 1 0.308736298077974E-05 0.000000000000000E+00 z1= 2 0.366798527127214E-05 0.000000000000000E+00 z1= 3 -.570495110539084E-02 0.000000000000000E+00 alpha(00000168)=0.000000000000000E+00 beta (00000169)=0.131674155034634E+02 gamma(00000169)=0.131674155034634E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.17490E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 169 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000169)=0.000000000000000E+00 beta (00000170)=0.134341391817252E+02 gamma(00000170)=0.134341391817252E+02 lr_calc_dens: Charge drift due to real space implementation = -0.16034E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 170 z1= 1 -.493720764961753E-06 0.000000000000000E+00 z1= 2 -.379661529831350E-05 0.000000000000000E+00 z1= 3 0.452806364648359E-02 0.000000000000000E+00 alpha(00000170)=0.000000000000000E+00 beta (00000171)=0.131624427183747E+02 gamma(00000171)=0.131624427183747E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.96203E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 171 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000171)=0.000000000000000E+00 beta (00000172)=0.134799143811134E+02 gamma(00000172)=0.134799143811134E+02 lr_calc_dens: Charge drift due to real space implementation = 0.13831E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 172 z1= 1 -.225618107411574E-05 0.000000000000000E+00 z1= 2 0.435028247880459E-05 0.000000000000000E+00 z1= 3 -.380835545627599E-02 0.000000000000000E+00 alpha(00000172)=0.000000000000000E+00 beta (00000173)=0.130288733187663E+02 gamma(00000173)=0.130288733187663E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.39201E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 173 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000173)=0.000000000000000E+00 beta (00000174)=0.134909207394878E+02 gamma(00000174)=0.134909207394878E+02 lr_calc_dens: Charge drift due to real space implementation = -0.66131E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 174 z1= 1 0.511588230965690E-05 0.000000000000000E+00 z1= 2 -.504587402953977E-05 0.000000000000000E+00 z1= 3 0.351915513410334E-02 0.000000000000000E+00 alpha(00000174)=0.000000000000000E+00 beta (00000175)=0.130252639715901E+02 gamma(00000175)=0.130252639715901E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.56508E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 175 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000175)=0.000000000000000E+00 beta (00000176)=0.135094324236551E+02 gamma(00000176)=0.135094324236551E+02 lr_calc_dens: Charge drift due to real space implementation = 0.26281E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 176 z1= 1 -.819529746861538E-05 0.000000000000000E+00 z1= 2 0.609390103543801E-05 0.000000000000000E+00 z1= 3 -.329750734747547E-02 0.000000000000000E+00 alpha(00000176)=0.000000000000000E+00 beta (00000177)=0.130855864701734E+02 gamma(00000177)=0.130855864701734E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10867E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 177 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000177)=0.000000000000000E+00 beta (00000178)=0.135216216937318E+02 gamma(00000178)=0.135216216937318E+02 lr_calc_dens: Charge drift due to real space implementation = -0.40381E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 178 z1= 1 0.115457520797762E-04 0.000000000000000E+00 z1= 2 -.717987427189052E-05 0.000000000000000E+00 z1= 3 0.290798796691701E-02 0.000000000000000E+00 alpha(00000178)=0.000000000000000E+00 beta (00000179)=0.129887231466070E+02 gamma(00000179)=0.129887231466070E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.16392E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 179 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000179)=0.000000000000000E+00 beta (00000180)=0.133905325295342E+02 gamma(00000180)=0.133905325295342E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12500E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 180 z1= 1 -.148721726164508E-04 0.000000000000000E+00 z1= 2 0.845246043124826E-05 0.000000000000000E+00 z1= 3 -.236658925351011E-02 0.000000000000000E+00 alpha(00000180)=0.000000000000000E+00 beta (00000181)=0.129427393810533E+02 gamma(00000181)=0.129427393810533E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.14248E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 181 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000181)=0.000000000000000E+00 beta (00000182)=0.135756727654667E+02 gamma(00000182)=0.135756727654667E+02 lr_calc_dens: Charge drift due to real space implementation = -0.19982E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 182 z1= 1 0.178576280618073E-04 0.000000000000000E+00 z1= 2 -.947718463698147E-05 0.000000000000000E+00 z1= 3 0.183697301626937E-02 0.000000000000000E+00 alpha(00000182)=0.000000000000000E+00 beta (00000183)=0.130032699435539E+02 gamma(00000183)=0.130032699435539E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.44806E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 183 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000183)=0.000000000000000E+00 beta (00000184)=0.135295472388041E+02 gamma(00000184)=0.135295472388041E+02 lr_calc_dens: Charge drift due to real space implementation = 0.17852E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 184 z1= 1 -.210495966234613E-04 0.000000000000000E+00 z1= 2 0.106832030417421E-04 0.000000000000000E+00 z1= 3 -.171778112365285E-02 0.000000000000000E+00 alpha(00000184)=0.000000000000000E+00 beta (00000185)=0.130388566215857E+02 gamma(00000185)=0.130388566215857E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.29462E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 185 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000185)=0.000000000000000E+00 beta (00000186)=0.135860688212124E+02 gamma(00000186)=0.135860688212124E+02 lr_calc_dens: Charge drift due to real space implementation = -0.89582E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 186 z1= 1 0.241584174148684E-04 0.000000000000000E+00 z1= 2 -.111666141206966E-04 0.000000000000000E+00 z1= 3 0.200339939723230E-02 0.000000000000000E+00 alpha(00000186)=0.000000000000000E+00 beta (00000187)=0.130504925537118E+02 gamma(00000187)=0.130504925537118E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.24091E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 187 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000187)=0.000000000000000E+00 beta (00000188)=0.134877673334115E+02 gamma(00000188)=0.134877673334115E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11648E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 188 z1= 1 -.273114604504449E-04 0.000000000000000E+00 z1= 2 0.121139762220686E-04 0.000000000000000E+00 z1= 3 -.237753310532660E-02 0.000000000000000E+00 alpha(00000188)=0.000000000000000E+00 beta (00000189)=0.130656932536573E+02 gamma(00000189)=0.130656932536573E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.45606E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 189 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000189)=0.000000000000000E+00 beta (00000190)=0.134772098626982E+02 gamma(00000190)=0.134772098626982E+02 lr_calc_dens: Charge drift due to real space implementation = -0.58502E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 190 z1= 1 0.303646613011430E-04 0.000000000000000E+00 z1= 2 -.126520926518943E-04 0.000000000000000E+00 z1= 3 0.240771039688242E-02 0.000000000000000E+00 alpha(00000190)=0.000000000000000E+00 beta (00000191)=0.130082951809507E+02 gamma(00000191)=0.130082951809507E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.11678E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 191 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000191)=0.000000000000000E+00 beta (00000192)=0.135486837576091E+02 gamma(00000192)=0.135486837576091E+02 lr_calc_dens: Charge drift due to real space implementation = 0.82199E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 192 z1= 1 -.332653636433399E-04 0.000000000000000E+00 z1= 2 0.129517209804843E-04 0.000000000000000E+00 z1= 3 -.187023182684853E-02 0.000000000000000E+00 alpha(00000192)=0.000000000000000E+00 beta (00000193)=0.129874415139654E+02 gamma(00000193)=0.129874415139654E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10327E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 193 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000193)=0.000000000000000E+00 beta (00000194)=0.136054161110670E+02 gamma(00000194)=0.136054161110670E+02 lr_calc_dens: Charge drift due to real space implementation = -0.14221E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 194 z1= 1 0.361699193891666E-04 0.000000000000000E+00 z1= 2 -.127942336526981E-04 0.000000000000000E+00 z1= 3 0.111881543978693E-02 0.000000000000000E+00 alpha(00000194)=0.000000000000000E+00 beta (00000195)=0.130087197839756E+02 gamma(00000195)=0.130087197839756E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.33603E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 195 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000195)=0.000000000000000E+00 beta (00000196)=0.134224244002549E+02 gamma(00000196)=0.134224244002549E+02 lr_calc_dens: Charge drift due to real space implementation = 0.13760E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 196 z1= 1 -.394754256154468E-04 0.000000000000000E+00 z1= 2 0.130408152286860E-04 0.000000000000000E+00 z1= 3 -.699994879762195E-03 0.000000000000000E+00 alpha(00000196)=0.000000000000000E+00 beta (00000197)=0.129213743630795E+02 gamma(00000197)=0.129213743630795E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.15531E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 197 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000197)=0.000000000000000E+00 beta (00000198)=0.135076242401537E+02 gamma(00000198)=0.135076242401537E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11225E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 198 z1= 1 0.419525658502988E-04 0.000000000000000E+00 z1= 2 -.129896180981661E-04 0.000000000000000E+00 z1= 3 0.815869200850300E-03 0.000000000000000E+00 alpha(00000198)=0.000000000000000E+00 beta (00000199)=0.129454244393511E+02 gamma(00000199)=0.129454244393511E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.42143E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 199 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000199)=0.000000000000000E+00 beta (00000200)=0.135421107896438E+02 gamma(00000200)=0.135421107896438E+02 lr_calc_dens: Charge drift due to real space implementation = 0.87128E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 200 z1= 1 -.441382064399697E-04 0.000000000000000E+00 z1= 2 0.126306316837091E-04 0.000000000000000E+00 z1= 3 -.131138922597042E-02 0.000000000000000E+00 alpha(00000200)=0.000000000000000E+00 beta (00000201)=0.129374751802148E+02 gamma(00000201)=0.129374751802148E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.62202E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 201 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000201)=0.000000000000000E+00 beta (00000202)=0.135863843138439E+02 gamma(00000202)=0.135863843138439E+02 lr_calc_dens: Charge drift due to real space implementation = -0.48259E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 202 z1= 1 0.458865281865015E-04 0.000000000000000E+00 z1= 2 -.126508763861414E-04 0.000000000000000E+00 z1= 3 0.194764638419692E-02 0.000000000000000E+00 alpha(00000202)=0.000000000000000E+00 beta (00000203)=0.129334593827826E+02 gamma(00000203)=0.129334593827826E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.54954E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 203 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000203)=0.000000000000000E+00 beta (00000204)=0.136719934948638E+02 gamma(00000204)=0.136719934948638E+02 lr_calc_dens: Charge drift due to real space implementation = 0.27610E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 204 z1= 1 -.466878998748079E-04 0.000000000000000E+00 z1= 2 0.125632758041443E-04 0.000000000000000E+00 z1= 3 -.248303815606555E-02 0.000000000000000E+00 alpha(00000204)=0.000000000000000E+00 beta (00000205)=0.130163590220858E+02 gamma(00000205)=0.130163590220858E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.43263E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 205 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000205)=0.000000000000000E+00 beta (00000206)=0.135193705258322E+02 gamma(00000206)=0.135193705258322E+02 lr_calc_dens: Charge drift due to real space implementation = -0.25645E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 206 z1= 1 0.474036046736860E-04 0.000000000000000E+00 z1= 2 -.128231078699276E-04 0.000000000000000E+00 z1= 3 0.273577402141840E-02 0.000000000000000E+00 alpha(00000206)=0.000000000000000E+00 beta (00000207)=0.130106818067200E+02 gamma(00000207)=0.130106818067200E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.32808E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 207 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000207)=0.000000000000000E+00 beta (00000208)=0.135650280345003E+02 gamma(00000208)=0.135650280345003E+02 lr_calc_dens: Charge drift due to real space implementation = 0.36809E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 208 z1= 1 -.468868106388815E-04 0.000000000000000E+00 z1= 2 0.132758886865070E-04 0.000000000000000E+00 z1= 3 -.266312363983064E-02 0.000000000000000E+00 alpha(00000208)=0.000000000000000E+00 beta (00000209)=0.130009164060976E+02 gamma(00000209)=0.130009164060976E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.21751E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 209 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000209)=0.000000000000000E+00 beta (00000210)=0.135128524518128E+02 gamma(00000210)=0.135128524518128E+02 lr_calc_dens: Charge drift due to real space implementation = -0.72381E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 210 z1= 1 0.460295900105499E-04 0.000000000000000E+00 z1= 2 -.141454473400541E-04 0.000000000000000E+00 z1= 3 0.245124860103552E-02 0.000000000000000E+00 alpha(00000210)=0.000000000000000E+00 beta (00000211)=0.131298156060612E+02 gamma(00000211)=0.131298156060612E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.41370E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 211 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000211)=0.000000000000000E+00 beta (00000212)=0.134103493960147E+02 gamma(00000212)=0.134103493960147E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10426E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 212 z1= 1 -.460398169019307E-04 0.000000000000000E+00 z1= 2 0.151697013850322E-04 0.000000000000000E+00 z1= 3 -.248457741212650E-02 0.000000000000000E+00 alpha(00000212)=0.000000000000000E+00 beta (00000213)=0.129491365192866E+02 gamma(00000213)=0.129491365192866E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.11062E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 213 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000213)=0.000000000000000E+00 beta (00000214)=0.134629744646789E+02 gamma(00000214)=0.134629744646789E+02 lr_calc_dens: Charge drift due to real space implementation = -0.64406E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 214 z1= 1 0.452750602911330E-04 0.000000000000000E+00 z1= 2 -.157728996480823E-04 0.000000000000000E+00 z1= 3 0.304609925546796E-02 0.000000000000000E+00 alpha(00000214)=0.000000000000000E+00 beta (00000215)=0.129019984356858E+02 gamma(00000215)=0.129019984356858E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.16396E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 215 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000215)=0.000000000000000E+00 beta (00000216)=0.136414522632972E+02 gamma(00000216)=0.136414522632972E+02 lr_calc_dens: Charge drift due to real space implementation = -0.38219E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 216 z1= 1 -.437656844137587E-04 0.000000000000000E+00 z1= 2 0.159447599130721E-04 0.000000000000000E+00 z1= 3 -.399982766599388E-02 0.000000000000000E+00 alpha(00000216)=0.000000000000000E+00 beta (00000217)=0.130494000091780E+02 gamma(00000217)=0.130494000091780E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.11633E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 217 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000217)=0.000000000000000E+00 beta (00000218)=0.134277546977251E+02 gamma(00000218)=0.134277546977251E+02 lr_calc_dens: Charge drift due to real space implementation = 0.74825E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 218 z1= 1 0.434792564416897E-04 0.000000000000000E+00 z1= 2 -.163704393181743E-04 0.000000000000000E+00 z1= 3 0.504824968739022E-02 0.000000000000000E+00 alpha(00000218)=0.000000000000000E+00 beta (00000219)=0.130889007950711E+02 gamma(00000219)=0.130889007950711E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.48405E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 219 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000219)=0.000000000000000E+00 beta (00000220)=0.135108030727808E+02 gamma(00000220)=0.135108030727808E+02 lr_calc_dens: Charge drift due to real space implementation = -0.33855E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 220 z1= 1 -.431069018695200E-04 0.000000000000000E+00 z1= 2 0.170031977041685E-04 0.000000000000000E+00 z1= 3 -.566266549487439E-02 0.000000000000000E+00 alpha(00000220)=0.000000000000000E+00 beta (00000221)=0.129207867477463E+02 gamma(00000221)=0.129207867477463E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.43573E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 221 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000221)=0.000000000000000E+00 beta (00000222)=0.135536129207232E+02 gamma(00000222)=0.135536129207232E+02 lr_calc_dens: Charge drift due to real space implementation = 0.13083E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 222 z1= 1 0.419955941319217E-04 0.000000000000000E+00 z1= 2 -.170036161160001E-04 0.000000000000000E+00 z1= 3 0.578185819072977E-02 0.000000000000000E+00 alpha(00000222)=0.000000000000000E+00 beta (00000223)=0.130247822227930E+02 gamma(00000223)=0.130247822227930E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.56053E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 223 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000223)=0.000000000000000E+00 beta (00000224)=0.134721260622290E+02 gamma(00000224)=0.134721260622290E+02 lr_calc_dens: Charge drift due to real space implementation = 0.18186E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 224 z1= 1 -.415220587371353E-04 0.000000000000000E+00 z1= 2 0.171787447492462E-04 0.000000000000000E+00 z1= 3 -.567616338836384E-02 0.000000000000000E+00 alpha(00000224)=0.000000000000000E+00 beta (00000225)=0.130466203298729E+02 gamma(00000225)=0.130466203298729E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.63644E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 225 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000225)=0.000000000000000E+00 beta (00000226)=0.134620088972085E+02 gamma(00000226)=0.134620088972085E+02 lr_calc_dens: Charge drift due to real space implementation = -0.50916E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 226 z1= 1 0.410782670996155E-04 0.000000000000000E+00 z1= 2 -.169912742386028E-04 0.000000000000000E+00 z1= 3 0.545850107575669E-02 0.000000000000000E+00 alpha(00000226)=0.000000000000000E+00 beta (00000227)=0.131533487528627E+02 gamma(00000227)=0.131533487528627E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10326E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 227 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000227)=0.000000000000000E+00 beta (00000228)=0.134755019430413E+02 gamma(00000228)=0.134755019430413E+02 lr_calc_dens: Charge drift due to real space implementation = 0.53844E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 228 z1= 1 -.405229724687558E-04 0.000000000000000E+00 z1= 2 0.165656583348863E-04 0.000000000000000E+00 z1= 3 -.548058406362840E-02 0.000000000000000E+00 alpha(00000228)=0.000000000000000E+00 beta (00000229)=0.130820823471239E+02 gamma(00000229)=0.130820823471239E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.15316E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 229 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000229)=0.000000000000000E+00 beta (00000230)=0.134022198640747E+02 gamma(00000230)=0.134022198640747E+02 lr_calc_dens: Charge drift due to real space implementation = -0.40330E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 230 z1= 1 0.391231972306706E-04 0.000000000000000E+00 z1= 2 -.158450490252981E-04 0.000000000000000E+00 z1= 3 0.584803835243363E-02 0.000000000000000E+00 alpha(00000230)=0.000000000000000E+00 beta (00000231)=0.129896710709051E+02 gamma(00000231)=0.129896710709051E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.15484E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 231 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000231)=0.000000000000000E+00 beta (00000232)=0.136110529866650E+02 gamma(00000232)=0.136110529866650E+02 lr_calc_dens: Charge drift due to real space implementation = -0.37608E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 232 z1= 1 -.360504078650222E-04 0.000000000000000E+00 z1= 2 0.148362067113605E-04 0.000000000000000E+00 z1= 3 -.635790316311238E-02 0.000000000000000E+00 alpha(00000232)=0.000000000000000E+00 beta (00000233)=0.129893035199090E+02 gamma(00000233)=0.129893035199090E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14232E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 233 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000233)=0.000000000000000E+00 beta (00000234)=0.134166357066615E+02 gamma(00000234)=0.134166357066615E+02 lr_calc_dens: Charge drift due to real space implementation = 0.62444E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 234 z1= 1 0.332965048808013E-04 0.000000000000000E+00 z1= 2 -.139762768918998E-04 0.000000000000000E+00 z1= 3 0.700336751254347E-02 0.000000000000000E+00 alpha(00000234)=0.000000000000000E+00 beta (00000235)=0.131160354946820E+02 gamma(00000235)=0.131160354946820E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12593E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 235 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000235)=0.000000000000000E+00 beta (00000236)=0.135054751230179E+02 gamma(00000236)=0.135054751230179E+02 lr_calc_dens: Charge drift due to real space implementation = -0.71088E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 236 z1= 1 -.307507029471657E-04 0.000000000000000E+00 z1= 2 0.131060701384129E-04 0.000000000000000E+00 z1= 3 -.752372431223407E-02 0.000000000000000E+00 alpha(00000236)=0.000000000000000E+00 beta (00000237)=0.130734539079083E+02 gamma(00000237)=0.130734539079083E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.11411E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 237 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000237)=0.000000000000000E+00 beta (00000238)=0.134611662534792E+02 gamma(00000238)=0.134611662534792E+02 lr_calc_dens: Charge drift due to real space implementation = 0.60718E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 238 z1= 1 0.285308686155855E-04 0.000000000000000E+00 z1= 2 -.125083789300432E-04 0.000000000000000E+00 z1= 3 0.781480870497156E-02 0.000000000000000E+00 alpha(00000238)=0.000000000000000E+00 beta (00000239)=0.130535973356678E+02 gamma(00000239)=0.130535973356678E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10978E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 239 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000239)=0.000000000000000E+00 beta (00000240)=0.134777258299090E+02 gamma(00000240)=0.134777258299090E+02 lr_calc_dens: Charge drift due to real space implementation = -0.32670E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 240 z1= 1 -.265564979733417E-04 0.000000000000000E+00 z1= 2 0.117168942673364E-04 0.000000000000000E+00 z1= 3 -.774498037417049E-02 0.000000000000000E+00 alpha(00000240)=0.000000000000000E+00 beta (00000241)=0.130567083487760E+02 gamma(00000241)=0.130567083487760E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12329E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 241 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000241)=0.000000000000000E+00 beta (00000242)=0.134216880835068E+02 gamma(00000242)=0.134216880835068E+02 lr_calc_dens: Charge drift due to real space implementation = 0.99453E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 242 z1= 1 0.246575106865322E-04 0.000000000000000E+00 z1= 2 -.111561127598248E-04 0.000000000000000E+00 z1= 3 0.747064150208025E-02 0.000000000000000E+00 alpha(00000242)=0.000000000000000E+00 beta (00000243)=0.130712445807856E+02 gamma(00000243)=0.130712445807856E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.15253E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 243 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000243)=0.000000000000000E+00 beta (00000244)=0.134849924473936E+02 gamma(00000244)=0.134849924473936E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11281E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 244 z1= 1 -.222648488382311E-04 0.000000000000000E+00 z1= 2 0.108091723578226E-04 0.000000000000000E+00 z1= 3 -.724239824428674E-02 0.000000000000000E+00 alpha(00000244)=0.000000000000000E+00 beta (00000245)=0.130975059710861E+02 gamma(00000245)=0.130975059710861E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.18694E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 245 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000245)=0.000000000000000E+00 beta (00000246)=0.134373253174853E+02 gamma(00000246)=0.134373253174853E+02 lr_calc_dens: Charge drift due to real space implementation = 0.53441E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 246 z1= 1 0.195007835075756E-04 0.000000000000000E+00 z1= 2 -.107295055059051E-04 0.000000000000000E+00 z1= 3 0.733257531011639E-02 0.000000000000000E+00 alpha(00000246)=0.000000000000000E+00 beta (00000247)=0.130531073495304E+02 gamma(00000247)=0.130531073495304E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.18236E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 247 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000247)=0.000000000000000E+00 beta (00000248)=0.134549783074373E+02 gamma(00000248)=0.134549783074373E+02 lr_calc_dens: Charge drift due to real space implementation = -0.96739E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 248 z1= 1 -.167064459187409E-04 0.000000000000000E+00 z1= 2 0.104462673181629E-04 0.000000000000000E+00 z1= 3 -.762586903825692E-02 0.000000000000000E+00 alpha(00000248)=0.000000000000000E+00 beta (00000249)=0.129959700310076E+02 gamma(00000249)=0.129959700310076E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13964E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 249 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000249)=0.000000000000000E+00 beta (00000250)=0.135646547421996E+02 gamma(00000250)=0.135646547421996E+02 lr_calc_dens: Charge drift due to real space implementation = 0.93386E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 250 z1= 1 0.141918637487587E-04 0.000000000000000E+00 z1= 2 -.100636971592652E-04 0.000000000000000E+00 z1= 3 0.789539038391528E-02 0.000000000000000E+00 alpha(00000250)=0.000000000000000E+00 beta (00000251)=0.130267998936403E+02 gamma(00000251)=0.130267998936403E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11906E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 251 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000251)=0.000000000000000E+00 beta (00000252)=0.134747007633970E+02 gamma(00000252)=0.134747007633970E+02 lr_calc_dens: Charge drift due to real space implementation = -0.70605E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 252 z1= 1 -.123427750839895E-04 0.000000000000000E+00 z1= 2 0.944629311914139E-05 0.000000000000000E+00 z1= 3 -.815571170750148E-02 0.000000000000000E+00 alpha(00000252)=0.000000000000000E+00 beta (00000253)=0.130352883201872E+02 gamma(00000253)=0.130352883201872E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14664E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 253 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000253)=0.000000000000000E+00 beta (00000254)=0.134313599541138E+02 gamma(00000254)=0.134313599541138E+02 lr_calc_dens: Charge drift due to real space implementation = 0.90077E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 254 z1= 1 0.110349449889866E-04 0.000000000000000E+00 z1= 2 -.890894859997712E-05 0.000000000000000E+00 z1= 3 0.831452835867322E-02 0.000000000000000E+00 alpha(00000254)=0.000000000000000E+00 beta (00000255)=0.132054837594744E+02 gamma(00000255)=0.132054837594744E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.16571E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 255 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000255)=0.000000000000000E+00 beta (00000256)=0.134498737875546E+02 gamma(00000256)=0.134498737875546E+02 lr_calc_dens: Charge drift due to real space implementation = -0.14545E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 256 z1= 1 -.103990693787121E-04 0.000000000000000E+00 z1= 2 0.839009185699491E-05 0.000000000000000E+00 z1= 3 -.842638378662931E-02 0.000000000000000E+00 alpha(00000256)=0.000000000000000E+00 beta (00000257)=0.130818429431109E+02 gamma(00000257)=0.130818429431109E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12389E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 257 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000257)=0.000000000000000E+00 beta (00000258)=0.133661887335965E+02 gamma(00000258)=0.133661887335965E+02 lr_calc_dens: Charge drift due to real space implementation = 0.15153E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 258 z1= 1 0.103740176818865E-04 0.000000000000000E+00 z1= 2 -.799654583076782E-05 0.000000000000000E+00 z1= 3 0.839475755709208E-02 0.000000000000000E+00 alpha(00000258)=0.000000000000000E+00 beta (00000259)=0.130377299646755E+02 gamma(00000259)=0.130377299646755E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.74636E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 259 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000259)=0.000000000000000E+00 beta (00000260)=0.135026042785078E+02 gamma(00000260)=0.135026042785078E+02 lr_calc_dens: Charge drift due to real space implementation = -0.96760E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 260 z1= 1 -.107193035348135E-04 0.000000000000000E+00 z1= 2 0.752914733010712E-05 0.000000000000000E+00 z1= 3 -.810522719191799E-02 0.000000000000000E+00 alpha(00000260)=0.000000000000000E+00 beta (00000261)=0.128221208042946E+02 gamma(00000261)=0.128221208042946E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.87615E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 261 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000261)=0.000000000000000E+00 beta (00000262)=0.135147987156670E+02 gamma(00000262)=0.135147987156670E+02 lr_calc_dens: Charge drift due to real space implementation = 0.64790E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 262 z1= 1 0.111655730875120E-04 0.000000000000000E+00 z1= 2 -.718047403470909E-05 0.000000000000000E+00 z1= 3 0.776511351090097E-02 0.000000000000000E+00 alpha(00000262)=0.000000000000000E+00 beta (00000263)=0.129512369230344E+02 gamma(00000263)=0.129512369230344E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12335E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 263 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000263)=0.000000000000000E+00 beta (00000264)=0.136948057045150E+02 gamma(00000264)=0.136948057045150E+02 lr_calc_dens: Charge drift due to real space implementation = -0.97949E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 264 z1= 1 -.115483304387615E-04 0.000000000000000E+00 z1= 2 0.716153693132389E-05 0.000000000000000E+00 z1= 3 -.765566993575179E-02 0.000000000000000E+00 alpha(00000264)=0.000000000000000E+00 beta (00000265)=0.129019551705555E+02 gamma(00000265)=0.129019551705555E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10263E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 265 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000265)=0.000000000000000E+00 beta (00000266)=0.134849295979590E+02 gamma(00000266)=0.134849295979590E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11765E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 266 z1= 1 0.117726633997762E-04 0.000000000000000E+00 z1= 2 -.751818812905036E-05 0.000000000000000E+00 z1= 3 0.766385418776775E-02 0.000000000000000E+00 alpha(00000266)=0.000000000000000E+00 beta (00000267)=0.129562568192271E+02 gamma(00000267)=0.129562568192271E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.58528E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 267 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000267)=0.000000000000000E+00 beta (00000268)=0.135386805561185E+02 gamma(00000268)=0.135386805561185E+02 lr_calc_dens: Charge drift due to real space implementation = -0.98313E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 268 z1= 1 -.115249805630020E-04 0.000000000000000E+00 z1= 2 0.777648221468622E-05 0.000000000000000E+00 z1= 3 -.758825338146346E-02 0.000000000000000E+00 alpha(00000268)=0.000000000000000E+00 beta (00000269)=0.129825757893975E+02 gamma(00000269)=0.129825757893975E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.53435E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 269 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000269)=0.000000000000000E+00 beta (00000270)=0.135874515883898E+02 gamma(00000270)=0.135874515883898E+02 lr_calc_dens: Charge drift due to real space implementation = 0.85973E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 270 z1= 1 0.110490712910948E-04 0.000000000000000E+00 z1= 2 -.807735158972484E-05 0.000000000000000E+00 z1= 3 0.754958078060719E-02 0.000000000000000E+00 alpha(00000270)=0.000000000000000E+00 beta (00000271)=0.129599834466541E+02 gamma(00000271)=0.129599834466541E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.82336E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 271 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000271)=0.000000000000000E+00 beta (00000272)=0.135588434707470E+02 gamma(00000272)=0.135588434707470E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12086E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 272 z1= 1 -.109723832273469E-04 0.000000000000000E+00 z1= 2 0.777326809100348E-05 0.000000000000000E+00 z1= 3 -.755955876253141E-02 0.000000000000000E+00 alpha(00000272)=0.000000000000000E+00 beta (00000273)=0.129621832637669E+02 gamma(00000273)=0.129621832637669E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.79889E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 273 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000273)=0.000000000000000E+00 beta (00000274)=0.135853799106786E+02 gamma(00000274)=0.135853799106786E+02 lr_calc_dens: Charge drift due to real space implementation = 0.16713E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 274 z1= 1 0.112948786435207E-04 0.000000000000000E+00 z1= 2 -.759919221273949E-05 0.000000000000000E+00 z1= 3 0.739047423822194E-02 0.000000000000000E+00 alpha(00000274)=0.000000000000000E+00 beta (00000275)=0.128108501529995E+02 gamma(00000275)=0.128108501529995E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.13203E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 275 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000275)=0.000000000000000E+00 beta (00000276)=0.134881210338191E+02 gamma(00000276)=0.134881210338191E+02 lr_calc_dens: Charge drift due to real space implementation = -0.14643E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 276 z1= 1 -.119326840651900E-04 0.000000000000000E+00 z1= 2 0.714114267580515E-05 0.000000000000000E+00 z1= 3 -.678538991388084E-02 0.000000000000000E+00 alpha(00000276)=0.000000000000000E+00 beta (00000277)=0.131266562038380E+02 gamma(00000277)=0.131266562038380E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.49854E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 277 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000277)=0.000000000000000E+00 beta (00000278)=0.135058026366532E+02 gamma(00000278)=0.135058026366532E+02 lr_calc_dens: Charge drift due to real space implementation = 0.68701E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 278 z1= 1 0.131123013008463E-04 0.000000000000000E+00 z1= 2 -.726834268423559E-05 0.000000000000000E+00 z1= 3 0.600047840716064E-02 0.000000000000000E+00 alpha(00000278)=0.000000000000000E+00 beta (00000279)=0.130246871262987E+02 gamma(00000279)=0.130246871262987E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.39420E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 279 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000279)=0.000000000000000E+00 beta (00000280)=0.136140774264080E+02 gamma(00000280)=0.136140774264080E+02 lr_calc_dens: Charge drift due to real space implementation = -0.17896E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 280 z1= 1 -.142008252834686E-04 0.000000000000000E+00 z1= 2 0.709226909901017E-05 0.000000000000000E+00 z1= 3 -.511919248319718E-02 0.000000000000000E+00 alpha(00000280)=0.000000000000000E+00 beta (00000281)=0.129858648943513E+02 gamma(00000281)=0.129858648943513E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.59359E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 281 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000281)=0.000000000000000E+00 beta (00000282)=0.136313740550083E+02 gamma(00000282)=0.136313740550083E+02 lr_calc_dens: Charge drift due to real space implementation = 0.21984E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 282 z1= 1 0.154270203668934E-04 0.000000000000000E+00 z1= 2 -.697000295340874E-05 0.000000000000000E+00 z1= 3 0.460240610631027E-02 0.000000000000000E+00 alpha(00000282)=0.000000000000000E+00 beta (00000283)=0.129740747135020E+02 gamma(00000283)=0.129740747135020E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.34553E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 283 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000283)=0.000000000000000E+00 beta (00000284)=0.135694458899412E+02 gamma(00000284)=0.135694458899412E+02 lr_calc_dens: Charge drift due to real space implementation = -0.52305E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 284 z1= 1 -.168970631492168E-04 0.000000000000000E+00 z1= 2 0.695513017822121E-05 0.000000000000000E+00 z1= 3 -.456325976210852E-02 0.000000000000000E+00 alpha(00000284)=0.000000000000000E+00 beta (00000285)=0.127969920026727E+02 gamma(00000285)=0.127969920026727E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.35012E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 285 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000285)=0.000000000000000E+00 beta (00000286)=0.135930071183847E+02 gamma(00000286)=0.135930071183847E+02 lr_calc_dens: Charge drift due to real space implementation = 0.82043E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 286 z1= 1 0.183203377780704E-04 0.000000000000000E+00 z1= 2 -.747259940135313E-05 0.000000000000000E+00 z1= 3 0.467989742393064E-02 0.000000000000000E+00 alpha(00000286)=0.000000000000000E+00 beta (00000287)=0.130065478647951E+02 gamma(00000287)=0.130065478647951E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11084E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 287 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000287)=0.000000000000000E+00 beta (00000288)=0.136080944368536E+02 gamma(00000288)=0.136080944368536E+02 lr_calc_dens: Charge drift due to real space implementation = -0.99575E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 288 z1= 1 -.205318546983243E-04 0.000000000000000E+00 z1= 2 0.828510475925972E-05 0.000000000000000E+00 z1= 3 -.485056497070198E-02 0.000000000000000E+00 alpha(00000288)=0.000000000000000E+00 beta (00000289)=0.130540895824471E+02 gamma(00000289)=0.130540895824471E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.29749E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 289 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000289)=0.000000000000000E+00 beta (00000290)=0.135500576882890E+02 gamma(00000290)=0.135500576882890E+02 lr_calc_dens: Charge drift due to real space implementation = 0.88317E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 290 z1= 1 0.231207517684581E-04 0.000000000000000E+00 z1= 2 -.965480861663313E-05 0.000000000000000E+00 z1= 3 0.476988418762835E-02 0.000000000000000E+00 alpha(00000290)=0.000000000000000E+00 beta (00000291)=0.129392262425892E+02 gamma(00000291)=0.129392262425892E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.59874E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 291 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000291)=0.000000000000000E+00 beta (00000292)=0.135020847800496E+02 gamma(00000292)=0.135020847800496E+02 lr_calc_dens: Charge drift due to real space implementation = -0.62942E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 292 z1= 1 -.255143284562240E-04 0.000000000000000E+00 z1= 2 0.109942758831554E-04 0.000000000000000E+00 z1= 3 -.425949715833951E-02 0.000000000000000E+00 alpha(00000292)=0.000000000000000E+00 beta (00000293)=0.130367067489116E+02 gamma(00000293)=0.130367067489116E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.70297E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 293 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000293)=0.000000000000000E+00 beta (00000294)=0.134081931654365E+02 gamma(00000294)=0.134081931654365E+02 lr_calc_dens: Charge drift due to real space implementation = 0.52536E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 294 z1= 1 0.282478595622677E-04 0.000000000000000E+00 z1= 2 -.119477566285343E-04 0.000000000000000E+00 z1= 3 0.360535817540036E-02 0.000000000000000E+00 alpha(00000294)=0.000000000000000E+00 beta (00000295)=0.129828434424003E+02 gamma(00000295)=0.129828434424003E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.96660E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 295 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000295)=0.000000000000000E+00 beta (00000296)=0.135179870125216E+02 gamma(00000296)=0.135179870125216E+02 lr_calc_dens: Charge drift due to real space implementation = -0.60944E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 296 z1= 1 -.308590734049012E-04 0.000000000000000E+00 z1= 2 0.121646175630490E-04 0.000000000000000E+00 z1= 3 -.278206531158396E-02 0.000000000000000E+00 alpha(00000296)=0.000000000000000E+00 beta (00000297)=0.129679077897153E+02 gamma(00000297)=0.129679077897153E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.83276E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 297 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000297)=0.000000000000000E+00 beta (00000298)=0.135972742868887E+02 gamma(00000298)=0.135972742868887E+02 lr_calc_dens: Charge drift due to real space implementation = -0.39881E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 298 z1= 1 0.334865472300244E-04 0.000000000000000E+00 z1= 2 -.120618400081432E-04 0.000000000000000E+00 z1= 3 0.198092983201047E-02 0.000000000000000E+00 alpha(00000298)=0.000000000000000E+00 beta (00000299)=0.129868952590755E+02 gamma(00000299)=0.129868952590755E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14592E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 299 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000299)=0.000000000000000E+00 beta (00000300)=0.134800312092811E+02 gamma(00000300)=0.134800312092811E+02 lr_calc_dens: Charge drift due to real space implementation = 0.97370E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 300 z1= 1 -.364736930989567E-04 0.000000000000000E+00 z1= 2 0.113721515583113E-04 0.000000000000000E+00 z1= 3 -.157942315555547E-02 0.000000000000000E+00 alpha(00000300)=0.000000000000000E+00 beta (00000301)=0.129827346732343E+02 gamma(00000301)=0.129827346732343E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.18605E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 301 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000301)=0.000000000000000E+00 beta (00000302)=0.135106431327596E+02 gamma(00000302)=0.135106431327596E+02 lr_calc_dens: Charge drift due to real space implementation = 0.54260E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 302 z1= 1 0.388991464187259E-04 0.000000000000000E+00 z1= 2 -.106667988253259E-04 0.000000000000000E+00 z1= 3 0.148192148875288E-02 0.000000000000000E+00 alpha(00000302)=0.000000000000000E+00 beta (00000303)=0.130187913187499E+02 gamma(00000303)=0.130187913187499E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.19013E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 303 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000303)=0.000000000000000E+00 beta (00000304)=0.135405755871365E+02 gamma(00000304)=0.135405755871365E+02 lr_calc_dens: Charge drift due to real space implementation = -0.79127E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 304 z1= 1 -.406517800299337E-04 0.000000000000000E+00 z1= 2 0.101407075538953E-04 0.000000000000000E+00 z1= 3 -.133027730576680E-02 0.000000000000000E+00 alpha(00000304)=0.000000000000000E+00 beta (00000305)=0.129970451111996E+02 gamma(00000305)=0.129970451111996E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.83879E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 305 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000305)=0.000000000000000E+00 beta (00000306)=0.134914296945131E+02 gamma(00000306)=0.134914296945131E+02 lr_calc_dens: Charge drift due to real space implementation = 0.48810E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 306 z1= 1 0.418659276728135E-04 0.000000000000000E+00 z1= 2 -.987012896614864E-05 0.000000000000000E+00 z1= 3 0.853056053491385E-03 0.000000000000000E+00 alpha(00000306)=0.000000000000000E+00 beta (00000307)=0.129925306423551E+02 gamma(00000307)=0.129925306423551E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13212E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 307 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000307)=0.000000000000000E+00 beta (00000308)=0.135309339946405E+02 gamma(00000308)=0.135309339946405E+02 lr_calc_dens: Charge drift due to real space implementation = 0.20002E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 308 z1= 1 -.428664915272180E-04 0.000000000000000E+00 z1= 2 0.956742940518430E-05 0.000000000000000E+00 z1= 3 -.133240057464300E-03 0.000000000000000E+00 alpha(00000308)=0.000000000000000E+00 beta (00000309)=0.128881413331585E+02 gamma(00000309)=0.128881413331585E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12556E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 309 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000309)=0.000000000000000E+00 beta (00000310)=0.135467786591101E+02 gamma(00000310)=0.135467786591101E+02 lr_calc_dens: Charge drift due to real space implementation = -0.75864E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 310 z1= 1 0.432293947924194E-04 0.000000000000000E+00 z1= 2 -.912687637563149E-05 0.000000000000000E+00 z1= 3 -.445399352367976E-03 0.000000000000000E+00 alpha(00000310)=0.000000000000000E+00 beta (00000311)=0.129817508942018E+02 gamma(00000311)=0.129817508942018E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.51670E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 311 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000311)=0.000000000000000E+00 beta (00000312)=0.135758002403394E+02 gamma(00000312)=0.135758002403394E+02 lr_calc_dens: Charge drift due to real space implementation = 0.39156E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 312 z1= 1 -.434688829669302E-04 0.000000000000000E+00 z1= 2 0.901419462668374E-05 0.000000000000000E+00 z1= 3 0.699453831876256E-03 0.000000000000000E+00 alpha(00000312)=0.000000000000000E+00 beta (00000313)=0.128986793375032E+02 gamma(00000313)=0.128986793375032E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.16853E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 313 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000313)=0.000000000000000E+00 beta (00000314)=0.135151859108546E+02 gamma(00000314)=0.135151859108546E+02 lr_calc_dens: Charge drift due to real space implementation = 0.38849E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 314 z1= 1 0.437359484322241E-04 0.000000000000000E+00 z1= 2 -.851889290760540E-05 0.000000000000000E+00 z1= 3 -.811586163102438E-03 0.000000000000000E+00 alpha(00000314)=0.000000000000000E+00 beta (00000315)=0.129536379589517E+02 gamma(00000315)=0.129536379589517E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.73381E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 315 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000315)=0.000000000000000E+00 beta (00000316)=0.134550349252390E+02 gamma(00000316)=0.134550349252390E+02 lr_calc_dens: Charge drift due to real space implementation = -0.46277E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 316 z1= 1 -.444456596162806E-04 0.000000000000000E+00 z1= 2 0.809181833722875E-05 0.000000000000000E+00 z1= 3 0.111058735855061E-02 0.000000000000000E+00 alpha(00000316)=0.000000000000000E+00 beta (00000317)=0.129675004617980E+02 gamma(00000317)=0.129675004617980E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.13407E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 317 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000317)=0.000000000000000E+00 beta (00000318)=0.136011087966163E+02 gamma(00000318)=0.136011087966163E+02 lr_calc_dens: Charge drift due to real space implementation = -0.15019E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 318 z1= 1 0.445647177626529E-04 0.000000000000000E+00 z1= 2 -.762138762470686E-05 0.000000000000000E+00 z1= 3 -.152817542548351E-02 0.000000000000000E+00 alpha(00000318)=0.000000000000000E+00 beta (00000319)=0.129937899512972E+02 gamma(00000319)=0.129937899512972E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.11472E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 319 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000319)=0.000000000000000E+00 beta (00000320)=0.134966783897224E+02 gamma(00000320)=0.134966783897224E+02 lr_calc_dens: Charge drift due to real space implementation = 0.34168E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 320 z1= 1 -.452458173711886E-04 0.000000000000000E+00 z1= 2 0.726293039144667E-05 0.000000000000000E+00 z1= 3 0.193534921592578E-02 0.000000000000000E+00 alpha(00000320)=0.000000000000000E+00 beta (00000321)=0.129605942723535E+02 gamma(00000321)=0.129605942723535E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.86136E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 321 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000321)=0.000000000000000E+00 beta (00000322)=0.135026357559205E+02 gamma(00000322)=0.135026357559205E+02 lr_calc_dens: Charge drift due to real space implementation = -0.16022E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 322 z1= 1 0.457756780484954E-04 0.000000000000000E+00 z1= 2 -.653542451411562E-05 0.000000000000000E+00 z1= 3 -.235235504237737E-02 0.000000000000000E+00 alpha(00000322)=0.000000000000000E+00 beta (00000323)=0.129943525608321E+02 gamma(00000323)=0.129943525608321E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.93444E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 323 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000323)=0.000000000000000E+00 beta (00000324)=0.133560953558459E+02 gamma(00000324)=0.133560953558459E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12285E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 324 z1= 1 -.466253331265284E-04 0.000000000000000E+00 z1= 2 0.571880240324773E-05 0.000000000000000E+00 z1= 3 0.295076770122744E-02 0.000000000000000E+00 alpha(00000324)=0.000000000000000E+00 beta (00000325)=0.130256688065736E+02 gamma(00000325)=0.130256688065736E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10834E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 325 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000325)=0.000000000000000E+00 beta (00000326)=0.135077284835305E+02 gamma(00000326)=0.135077284835305E+02 lr_calc_dens: Charge drift due to real space implementation = -0.20447E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 326 z1= 1 0.465765357424909E-04 0.000000000000000E+00 z1= 2 -.441592254022001E-05 0.000000000000000E+00 z1= 3 -.365388337806445E-02 0.000000000000000E+00 alpha(00000326)=0.000000000000000E+00 beta (00000327)=0.129949988132122E+02 gamma(00000327)=0.129949988132122E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12696E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 327 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000327)=0.000000000000000E+00 beta (00000328)=0.135937221828893E+02 gamma(00000328)=0.135937221828893E+02 lr_calc_dens: Charge drift due to real space implementation = 0.41397E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 328 z1= 1 -.457693902224946E-04 0.000000000000000E+00 z1= 2 0.271065112609286E-05 0.000000000000000E+00 z1= 3 0.441126816208742E-02 0.000000000000000E+00 alpha(00000328)=0.000000000000000E+00 beta (00000329)=0.130493771280058E+02 gamma(00000329)=0.130493771280058E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.14205E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 329 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000329)=0.000000000000000E+00 beta (00000330)=0.135442287109490E+02 gamma(00000330)=0.135442287109490E+02 lr_calc_dens: Charge drift due to real space implementation = -0.74206E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 330 z1= 1 0.451838160318028E-04 0.000000000000000E+00 z1= 2 -.995573378873250E-06 0.000000000000000E+00 z1= 3 -.508052508892024E-02 0.000000000000000E+00 alpha(00000330)=0.000000000000000E+00 beta (00000331)=0.129871195444579E+02 gamma(00000331)=0.129871195444579E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13770E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 331 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000331)=0.000000000000000E+00 beta (00000332)=0.135239824980560E+02 gamma(00000332)=0.135239824980560E+02 lr_calc_dens: Charge drift due to real space implementation = 0.96947E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 332 z1= 1 -.441340581615084E-04 0.000000000000000E+00 z1= 2 -.748379400790117E-06 0.000000000000000E+00 z1= 3 0.541970307694804E-02 0.000000000000000E+00 alpha(00000332)=0.000000000000000E+00 beta (00000333)=0.130549371655492E+02 gamma(00000333)=0.130549371655492E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10839E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 333 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000333)=0.000000000000000E+00 beta (00000334)=0.135341292015159E+02 gamma(00000334)=0.135341292015159E+02 lr_calc_dens: Charge drift due to real space implementation = -0.80441E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 334 z1= 1 0.431400096589532E-04 0.000000000000000E+00 z1= 2 0.261537655385515E-05 0.000000000000000E+00 z1= 3 -.547227313764815E-02 0.000000000000000E+00 alpha(00000334)=0.000000000000000E+00 beta (00000335)=0.130547028927640E+02 gamma(00000335)=0.130547028927640E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.93020E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 335 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000335)=0.000000000000000E+00 beta (00000336)=0.135549950342174E+02 gamma(00000336)=0.135549950342174E+02 lr_calc_dens: Charge drift due to real space implementation = 0.46333E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 336 z1= 1 -.422061670102544E-04 0.000000000000000E+00 z1= 2 -.441323784109745E-05 0.000000000000000E+00 z1= 3 0.532577709373401E-02 0.000000000000000E+00 alpha(00000336)=0.000000000000000E+00 beta (00000337)=0.131115572751821E+02 gamma(00000337)=0.131115572751821E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.99977E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 337 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000337)=0.000000000000000E+00 beta (00000338)=0.135027669377880E+02 gamma(00000338)=0.135027669377880E+02 lr_calc_dens: Charge drift due to real space implementation = -0.20997E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 338 z1= 1 0.421036314533986E-04 0.000000000000000E+00 z1= 2 0.602697499556327E-05 0.000000000000000E+00 z1= 3 -.538514954425470E-02 0.000000000000000E+00 alpha(00000338)=0.000000000000000E+00 beta (00000339)=0.129219713248836E+02 gamma(00000339)=0.129219713248836E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12296E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 339 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000339)=0.000000000000000E+00 beta (00000340)=0.134498444109533E+02 gamma(00000340)=0.134498444109533E+02 lr_calc_dens: Charge drift due to real space implementation = 0.25710E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 340 z1= 1 -.420355522084867E-04 0.000000000000000E+00 z1= 2 -.713056879290734E-05 0.000000000000000E+00 z1= 3 0.587077062461035E-02 0.000000000000000E+00 alpha(00000340)=0.000000000000000E+00 beta (00000341)=0.129583408887108E+02 gamma(00000341)=0.129583408887108E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.13911E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 341 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000341)=0.000000000000000E+00 beta (00000342)=0.134914029484072E+02 gamma(00000342)=0.134914029484072E+02 lr_calc_dens: Charge drift due to real space implementation = -0.58780E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 342 z1= 1 0.418932182292045E-04 0.000000000000000E+00 z1= 2 0.823873412761976E-05 0.000000000000000E+00 z1= 3 -.675868500674170E-02 0.000000000000000E+00 alpha(00000342)=0.000000000000000E+00 beta (00000343)=0.129685371301874E+02 gamma(00000343)=0.129685371301874E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13419E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 343 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000343)=0.000000000000000E+00 beta (00000344)=0.134882446282065E+02 gamma(00000344)=0.134882446282065E+02 lr_calc_dens: Charge drift due to real space implementation = 0.92853E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 344 z1= 1 -.415304739546905E-04 0.000000000000000E+00 z1= 2 -.932784179207364E-05 0.000000000000000E+00 z1= 3 0.774635011311967E-02 0.000000000000000E+00 alpha(00000344)=0.000000000000000E+00 beta (00000345)=0.129611872283992E+02 gamma(00000345)=0.129611872283992E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12297E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 345 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000345)=0.000000000000000E+00 beta (00000346)=0.134570645094081E+02 gamma(00000346)=0.134570645094081E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12846E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 346 z1= 1 0.410563049308443E-04 0.000000000000000E+00 z1= 2 0.106151055346596E-04 0.000000000000000E+00 z1= 3 -.848345593154548E-02 0.000000000000000E+00 alpha(00000346)=0.000000000000000E+00 beta (00000347)=0.130703826469577E+02 gamma(00000347)=0.130703826469577E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.87059E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 347 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000347)=0.000000000000000E+00 beta (00000348)=0.134556076646130E+02 gamma(00000348)=0.134556076646130E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12693E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 348 z1= 1 -.407093273266130E-04 0.000000000000000E+00 z1= 2 -.118959053794245E-04 0.000000000000000E+00 z1= 3 0.881796356237442E-02 0.000000000000000E+00 alpha(00000348)=0.000000000000000E+00 beta (00000349)=0.130272666202883E+02 gamma(00000349)=0.130272666202883E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.67772E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 349 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000349)=0.000000000000000E+00 beta (00000350)=0.134566353472062E+02 gamma(00000350)=0.134566353472062E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11237E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 350 z1= 1 0.399812802791101E-04 0.000000000000000E+00 z1= 2 0.130605628029806E-04 0.000000000000000E+00 z1= 3 -.876112740688838E-02 0.000000000000000E+00 alpha(00000350)=0.000000000000000E+00 beta (00000351)=0.130239064250935E+02 gamma(00000351)=0.130239064250935E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.64608E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 351 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000351)=0.000000000000000E+00 beta (00000352)=0.134823278757314E+02 gamma(00000352)=0.134823278757314E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10163E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 352 z1= 1 -.393103772851940E-04 0.000000000000000E+00 z1= 2 -.131969846570312E-04 0.000000000000000E+00 z1= 3 0.845469768315818E-02 0.000000000000000E+00 alpha(00000352)=0.000000000000000E+00 beta (00000353)=0.131233856842279E+02 gamma(00000353)=0.131233856842279E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.50945E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 353 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000353)=0.000000000000000E+00 beta (00000354)=0.135470862744963E+02 gamma(00000354)=0.135470862744963E+02 lr_calc_dens: Charge drift due to real space implementation = -0.64388E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 354 z1= 1 0.391115699502288E-04 0.000000000000000E+00 z1= 2 0.131846166571923E-04 0.000000000000000E+00 z1= 3 -.795526637073421E-02 0.000000000000000E+00 alpha(00000354)=0.000000000000000E+00 beta (00000355)=0.129697433812918E+02 gamma(00000355)=0.129697433812918E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.69621E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 355 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000355)=0.000000000000000E+00 beta (00000356)=0.134798930004091E+02 gamma(00000356)=0.134798930004091E+02 lr_calc_dens: Charge drift due to real space implementation = 0.54223E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 356 z1= 1 -.388843858976107E-04 0.000000000000000E+00 z1= 2 -.124279077159769E-04 0.000000000000000E+00 z1= 3 0.745646861920287E-02 0.000000000000000E+00 alpha(00000356)=0.000000000000000E+00 beta (00000357)=0.131004912701863E+02 gamma(00000357)=0.131004912701863E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.81171E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 357 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000357)=0.000000000000000E+00 beta (00000358)=0.134627938547754E+02 gamma(00000358)=0.134627938547754E+02 lr_calc_dens: Charge drift due to real space implementation = -0.70152E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 358 z1= 1 0.394259194018526E-04 0.000000000000000E+00 z1= 2 0.127292425747976E-04 0.000000000000000E+00 z1= 3 -.740417937232042E-02 0.000000000000000E+00 alpha(00000358)=0.000000000000000E+00 beta (00000359)=0.130051396564444E+02 gamma(00000359)=0.130051396564444E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.52276E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 359 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000359)=0.000000000000000E+00 beta (00000360)=0.134829982118009E+02 gamma(00000360)=0.134829982118009E+02 lr_calc_dens: Charge drift due to real space implementation = 0.42001E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 360 z1= 1 -.398517042217722E-04 0.000000000000000E+00 z1= 2 -.129699698467654E-04 0.000000000000000E+00 z1= 3 0.761463681839326E-02 0.000000000000000E+00 alpha(00000360)=0.000000000000000E+00 beta (00000361)=0.130468395113387E+02 gamma(00000361)=0.130468395113387E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.63469E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 361 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000361)=0.000000000000000E+00 beta (00000362)=0.134851681498124E+02 gamma(00000362)=0.134851681498124E+02 lr_calc_dens: Charge drift due to real space implementation = -0.26687E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 362 z1= 1 0.401627480669620E-04 0.000000000000000E+00 z1= 2 0.135042928241541E-04 0.000000000000000E+00 z1= 3 -.815887413400272E-02 0.000000000000000E+00 alpha(00000362)=0.000000000000000E+00 beta (00000363)=0.129562044614858E+02 gamma(00000363)=0.129562044614858E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.11953E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 363 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000363)=0.000000000000000E+00 beta (00000364)=0.136134251675066E+02 gamma(00000364)=0.136134251675066E+02 lr_calc_dens: Charge drift due to real space implementation = 0.90365E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 364 z1= 1 -.396388298967990E-04 0.000000000000000E+00 z1= 2 -.126675233455129E-04 0.000000000000000E+00 z1= 3 0.880894708765769E-02 0.000000000000000E+00 alpha(00000364)=0.000000000000000E+00 beta (00000365)=0.129033120203849E+02 gamma(00000365)=0.129033120203849E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12731E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 365 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000365)=0.000000000000000E+00 beta (00000366)=0.135424952011103E+02 gamma(00000366)=0.135424952011103E+02 lr_calc_dens: Charge drift due to real space implementation = -0.17311E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 366 z1= 1 0.393418158432516E-04 0.000000000000000E+00 z1= 2 0.119484472486327E-04 0.000000000000000E+00 z1= 3 -.916420089651386E-02 0.000000000000000E+00 alpha(00000366)=0.000000000000000E+00 beta (00000367)=0.130215419984972E+02 gamma(00000367)=0.130215419984972E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.52562E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 367 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000367)=0.000000000000000E+00 beta (00000368)=0.135608041910621E+02 gamma(00000368)=0.135608041910621E+02 lr_calc_dens: Charge drift due to real space implementation = 0.17807E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 368 z1= 1 -.394722183626588E-04 0.000000000000000E+00 z1= 2 -.106176426411121E-04 0.000000000000000E+00 z1= 3 0.893924372111553E-02 0.000000000000000E+00 alpha(00000368)=0.000000000000000E+00 beta (00000369)=0.129675269278204E+02 gamma(00000369)=0.129675269278204E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.22448E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 369 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000369)=0.000000000000000E+00 beta (00000370)=0.135986174445283E+02 gamma(00000370)=0.135986174445283E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11021E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 370 z1= 1 0.394432255071885E-04 0.000000000000000E+00 z1= 2 0.992840077255720E-05 0.000000000000000E+00 z1= 3 -.811726150717697E-02 0.000000000000000E+00 alpha(00000370)=0.000000000000000E+00 beta (00000371)=0.129247867447309E+02 gamma(00000371)=0.129247867447309E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.40666E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 371 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000371)=0.000000000000000E+00 beta (00000372)=0.134466651762850E+02 gamma(00000372)=0.134466651762850E+02 lr_calc_dens: Charge drift due to real space implementation = 0.32478E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 372 z1= 1 -.400282855688664E-04 0.000000000000000E+00 z1= 2 -.951325362774047E-05 0.000000000000000E+00 z1= 3 0.713604529718876E-02 0.000000000000000E+00 alpha(00000372)=0.000000000000000E+00 beta (00000373)=0.129742346243368E+02 gamma(00000373)=0.129742346243368E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13114E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 373 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000373)=0.000000000000000E+00 beta (00000374)=0.133964094276126E+02 gamma(00000374)=0.133964094276126E+02 lr_calc_dens: Charge drift due to real space implementation = 0.16802E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 374 z1= 1 0.414216653803242E-04 0.000000000000000E+00 z1= 2 0.971203271922390E-05 0.000000000000000E+00 z1= 3 -.637042651030468E-02 0.000000000000000E+00 alpha(00000374)=0.000000000000000E+00 beta (00000375)=0.129672064077042E+02 gamma(00000375)=0.129672064077042E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.33735E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 375 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000375)=0.000000000000000E+00 beta (00000376)=0.134424159213188E+02 gamma(00000376)=0.134424159213188E+02 lr_calc_dens: Charge drift due to real space implementation = -0.26039E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 376 z1= 1 -.424875891689108E-04 0.000000000000000E+00 z1= 2 -.918785974518295E-05 0.000000000000000E+00 z1= 3 0.599199575997992E-02 0.000000000000000E+00 alpha(00000376)=0.000000000000000E+00 beta (00000377)=0.129539693505647E+02 gamma(00000377)=0.129539693505647E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.91476E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 377 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000377)=0.000000000000000E+00 beta (00000378)=0.134203997535656E+02 gamma(00000378)=0.134203997535656E+02 lr_calc_dens: Charge drift due to real space implementation = -0.29367E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 378 z1= 1 0.432335138945087E-04 0.000000000000000E+00 z1= 2 0.823349822560137E-05 0.000000000000000E+00 z1= 3 -.621237610371747E-02 0.000000000000000E+00 alpha(00000378)=0.000000000000000E+00 beta (00000379)=0.131059709336754E+02 gamma(00000379)=0.131059709336754E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.11579E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 379 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000379)=0.000000000000000E+00 beta (00000380)=0.135476451354631E+02 gamma(00000380)=0.135476451354631E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12400E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 380 z1= 1 -.440235052875244E-04 0.000000000000000E+00 z1= 2 -.690144593754784E-05 0.000000000000000E+00 z1= 3 0.685036072428906E-02 0.000000000000000E+00 alpha(00000380)=0.000000000000000E+00 beta (00000381)=0.129973117807014E+02 gamma(00000381)=0.129973117807014E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.67557E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 381 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000381)=0.000000000000000E+00 beta (00000382)=0.134686832632491E+02 gamma(00000382)=0.134686832632491E+02 lr_calc_dens: Charge drift due to real space implementation = -0.18236E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 382 z1= 1 0.449493576440034E-04 0.000000000000000E+00 z1= 2 0.666231406707922E-05 0.000000000000000E+00 z1= 3 -.728330785729948E-02 0.000000000000000E+00 alpha(00000382)=0.000000000000000E+00 beta (00000383)=0.129878865480934E+02 gamma(00000383)=0.129878865480934E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.35921E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 383 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000383)=0.000000000000000E+00 beta (00000384)=0.135044728683845E+02 gamma(00000384)=0.135044728683845E+02 lr_calc_dens: Charge drift due to real space implementation = 0.14161E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 384 z1= 1 -.456070621788326E-04 0.000000000000000E+00 z1= 2 -.588500905476585E-05 0.000000000000000E+00 z1= 3 0.691785792017407E-02 0.000000000000000E+00 alpha(00000384)=0.000000000000000E+00 beta (00000385)=0.131469749010425E+02 gamma(00000385)=0.131469749010425E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10559E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 385 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000385)=0.000000000000000E+00 beta (00000386)=0.134269222700987E+02 gamma(00000386)=0.134269222700987E+02 lr_calc_dens: Charge drift due to real space implementation = -0.35318E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 386 z1= 1 0.469660669581446E-04 0.000000000000000E+00 z1= 2 0.449705302697197E-05 0.000000000000000E+00 z1= 3 -.607289473570228E-02 0.000000000000000E+00 alpha(00000386)=0.000000000000000E+00 beta (00000387)=0.130443429726257E+02 gamma(00000387)=0.130443429726257E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.72030E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 387 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000387)=0.000000000000000E+00 beta (00000388)=0.134840120104586E+02 gamma(00000388)=0.134840120104586E+02 lr_calc_dens: Charge drift due to real space implementation = -0.16853E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 388 z1= 1 -.481851283166069E-04 0.000000000000000E+00 z1= 2 -.254267713721759E-05 0.000000000000000E+00 z1= 3 0.519603757393833E-02 0.000000000000000E+00 alpha(00000388)=0.000000000000000E+00 beta (00000389)=0.129617729683234E+02 gamma(00000389)=0.129617729683234E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.16827E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 389 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000389)=0.000000000000000E+00 beta (00000390)=0.134945555879552E+02 gamma(00000390)=0.134945555879552E+02 lr_calc_dens: Charge drift due to real space implementation = 0.15446E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 390 z1= 1 0.496474035952113E-04 0.000000000000000E+00 z1= 2 0.134614486380476E-05 0.000000000000000E+00 z1= 3 -.467607069697382E-02 0.000000000000000E+00 alpha(00000390)=0.000000000000000E+00 beta (00000391)=0.130835890139464E+02 gamma(00000391)=0.130835890139464E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.15479E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 391 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000391)=0.000000000000000E+00 beta (00000392)=0.134608503351677E+02 gamma(00000392)=0.134608503351677E+02 lr_calc_dens: Charge drift due to real space implementation = -0.42535E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 392 z1= 1 -.515165003252566E-04 0.000000000000000E+00 z1= 2 -.778524220728727E-06 0.000000000000000E+00 z1= 3 0.462148206000804E-02 0.000000000000000E+00 alpha(00000392)=0.000000000000000E+00 beta (00000393)=0.129311726450633E+02 gamma(00000393)=0.129311726450633E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.57642E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 393 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000393)=0.000000000000000E+00 beta (00000394)=0.134335251255989E+02 gamma(00000394)=0.134335251255989E+02 lr_calc_dens: Charge drift due to real space implementation = -0.58150E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 394 z1= 1 0.528989424418016E-04 0.000000000000000E+00 z1= 2 0.110331010402945E-05 0.000000000000000E+00 z1= 3 -.476549604934984E-02 0.000000000000000E+00 alpha(00000394)=0.000000000000000E+00 beta (00000395)=0.132169807037907E+02 gamma(00000395)=0.132169807037907E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.42887E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 395 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000395)=0.000000000000000E+00 beta (00000396)=0.134644976773958E+02 gamma(00000396)=0.134644976773958E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11171E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 396 z1= 1 -.551643409074169E-04 0.000000000000000E+00 z1= 2 -.157389336035039E-05 0.000000000000000E+00 z1= 3 0.490913207280063E-02 0.000000000000000E+00 alpha(00000396)=0.000000000000000E+00 beta (00000397)=0.130709535829317E+02 gamma(00000397)=0.130709535829317E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.21309E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 397 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000397)=0.000000000000000E+00 beta (00000398)=0.135679386026299E+02 gamma(00000398)=0.135679386026299E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10544E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 398 z1= 1 0.563839644617971E-04 0.000000000000000E+00 z1= 2 0.186617589542308E-05 0.000000000000000E+00 z1= 3 -.465637463666066E-02 0.000000000000000E+00 alpha(00000398)=0.000000000000000E+00 beta (00000399)=0.130173542625977E+02 gamma(00000399)=0.130173542625977E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.77293E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 399 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000399)=0.000000000000000E+00 beta (00000400)=0.135107365187835E+02 gamma(00000400)=0.135107365187835E+02 lr_calc_dens: Charge drift due to real space implementation = 0.55698E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 400 z1= 1 -.575682893019262E-04 0.000000000000000E+00 z1= 2 -.189491586785512E-05 0.000000000000000E+00 z1= 3 0.411089044949134E-02 0.000000000000000E+00 alpha(00000400)=0.000000000000000E+00 beta (00000401)=0.130523737375002E+02 gamma(00000401)=0.130523737375002E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.86630E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 401 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000401)=0.000000000000000E+00 beta (00000402)=0.135654611949654E+02 gamma(00000402)=0.135654611949654E+02 lr_calc_dens: Charge drift due to real space implementation = -0.14265E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 402 z1= 1 0.585838230238446E-04 0.000000000000000E+00 z1= 2 0.191103440221431E-05 0.000000000000000E+00 z1= 3 -.357020414353258E-02 0.000000000000000E+00 alpha(00000402)=0.000000000000000E+00 beta (00000403)=0.129783265543722E+02 gamma(00000403)=0.129783265543722E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.62385E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 403 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000403)=0.000000000000000E+00 beta (00000404)=0.134593416877441E+02 gamma(00000404)=0.134593416877441E+02 lr_calc_dens: Charge drift due to real space implementation = 0.14072E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 404 z1= 1 -.594507286390410E-04 0.000000000000000E+00 z1= 2 -.144623526170016E-05 0.000000000000000E+00 z1= 3 0.315548778990398E-02 0.000000000000000E+00 alpha(00000404)=0.000000000000000E+00 beta (00000405)=0.130129410657041E+02 gamma(00000405)=0.130129410657041E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.50488E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 405 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000405)=0.000000000000000E+00 beta (00000406)=0.134333103825809E+02 gamma(00000406)=0.134333103825809E+02 lr_calc_dens: Charge drift due to real space implementation = -0.26598E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 406 z1= 1 0.599780298118308E-04 0.000000000000000E+00 z1= 2 0.134036466534487E-05 0.000000000000000E+00 z1= 3 -.282967486865093E-02 0.000000000000000E+00 alpha(00000406)=0.000000000000000E+00 beta (00000407)=0.130313684674856E+02 gamma(00000407)=0.130313684674856E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.46203E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 407 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000407)=0.000000000000000E+00 beta (00000408)=0.134230462055058E+02 gamma(00000408)=0.134230462055058E+02 lr_calc_dens: Charge drift due to real space implementation = 0.61073E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 408 z1= 1 -.599384974990975E-04 0.000000000000000E+00 z1= 2 -.928005378204708E-06 0.000000000000000E+00 z1= 3 0.260640218808862E-02 0.000000000000000E+00 alpha(00000408)=0.000000000000000E+00 beta (00000409)=0.131607443168887E+02 gamma(00000409)=0.131607443168887E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.84461E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 409 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000409)=0.000000000000000E+00 beta (00000410)=0.134155505582303E+02 gamma(00000410)=0.134155505582303E+02 lr_calc_dens: Charge drift due to real space implementation = -0.55020E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 410 z1= 1 0.600775724115893E-04 0.000000000000000E+00 z1= 2 0.371863289844914E-06 0.000000000000000E+00 z1= 3 -.227829323476124E-02 0.000000000000000E+00 alpha(00000410)=0.000000000000000E+00 beta (00000411)=0.131007379221864E+02 gamma(00000411)=0.131007379221864E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11661E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 411 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000411)=0.000000000000000E+00 beta (00000412)=0.134780402331957E+02 gamma(00000412)=0.134780402331957E+02 lr_calc_dens: Charge drift due to real space implementation = 0.87990E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 412 z1= 1 -.592940997062892E-04 0.000000000000000E+00 z1= 2 0.551797439934113E-06 0.000000000000000E+00 z1= 3 0.173479188745237E-02 0.000000000000000E+00 alpha(00000412)=0.000000000000000E+00 beta (00000413)=0.131237220172476E+02 gamma(00000413)=0.131237220172476E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.89301E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 413 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000413)=0.000000000000000E+00 beta (00000414)=0.134739347155328E+02 gamma(00000414)=0.134739347155328E+02 lr_calc_dens: Charge drift due to real space implementation = -0.75268E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 414 z1= 1 0.589354097851506E-04 0.000000000000000E+00 z1= 2 -.167275181949922E-05 0.000000000000000E+00 z1= 3 -.108872921046489E-02 0.000000000000000E+00 alpha(00000414)=0.000000000000000E+00 beta (00000415)=0.130401711926507E+02 gamma(00000415)=0.130401711926507E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.81920E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 415 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000415)=0.000000000000000E+00 beta (00000416)=0.134205305052211E+02 gamma(00000416)=0.134205305052211E+02 lr_calc_dens: Charge drift due to real space implementation = 0.15779E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 416 z1= 1 -.586756085816858E-04 0.000000000000000E+00 z1= 2 0.326099381042532E-05 0.000000000000000E+00 z1= 3 0.387892770817556E-03 0.000000000000000E+00 alpha(00000416)=0.000000000000000E+00 beta (00000417)=0.131264810612944E+02 gamma(00000417)=0.131264810612944E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10163E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 417 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000417)=0.000000000000000E+00 beta (00000418)=0.133907494248335E+02 gamma(00000418)=0.133907494248335E+02 lr_calc_dens: Charge drift due to real space implementation = -0.58434E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 418 z1= 1 0.590124677766506E-04 0.000000000000000E+00 z1= 2 -.471816824599463E-05 0.000000000000000E+00 z1= 3 0.299899073788986E-03 0.000000000000000E+00 alpha(00000418)=0.000000000000000E+00 beta (00000419)=0.130515526923059E+02 gamma(00000419)=0.130515526923059E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11763E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 419 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000419)=0.000000000000000E+00 beta (00000420)=0.133762913246844E+02 gamma(00000420)=0.133762913246844E+02 lr_calc_dens: Charge drift due to real space implementation = -0.42219E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 420 z1= 1 -.596248156898316E-04 0.000000000000000E+00 z1= 2 0.650090675418450E-05 0.000000000000000E+00 z1= 3 -.942892822891911E-03 0.000000000000000E+00 alpha(00000420)=0.000000000000000E+00 beta (00000421)=0.131327113957099E+02 gamma(00000421)=0.131327113957099E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12831E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 421 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000421)=0.000000000000000E+00 beta (00000422)=0.133628495735375E+02 gamma(00000422)=0.133628495735375E+02 lr_calc_dens: Charge drift due to real space implementation = 0.16006E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 422 z1= 1 0.612413417741885E-04 0.000000000000000E+00 z1= 2 -.867523390873769E-05 0.000000000000000E+00 z1= 3 0.151294127125661E-02 0.000000000000000E+00 alpha(00000422)=0.000000000000000E+00 beta (00000423)=0.130655929352762E+02 gamma(00000423)=0.130655929352762E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12540E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 423 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000423)=0.000000000000000E+00 beta (00000424)=0.134703742237130E+02 gamma(00000424)=0.134703742237130E+02 lr_calc_dens: Charge drift due to real space implementation = -0.26929E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 424 z1= 1 -.618810523492696E-04 0.000000000000000E+00 z1= 2 0.108195623083633E-04 0.000000000000000E+00 z1= 3 -.204346761351778E-02 0.000000000000000E+00 alpha(00000424)=0.000000000000000E+00 beta (00000425)=0.130206433488245E+02 gamma(00000425)=0.130206433488245E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10418E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 425 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000425)=0.000000000000000E+00 beta (00000426)=0.135217332516117E+02 gamma(00000426)=0.135217332516117E+02 lr_calc_dens: Charge drift due to real space implementation = 0.27093E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 426 z1= 1 0.615966827440697E-04 0.000000000000000E+00 z1= 2 -.131069860256965E-04 0.000000000000000E+00 z1= 3 0.252945013685648E-02 0.000000000000000E+00 alpha(00000426)=0.000000000000000E+00 beta (00000427)=0.130491051366438E+02 gamma(00000427)=0.130491051366438E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12254E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 427 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000427)=0.000000000000000E+00 beta (00000428)=0.134180517192002E+02 gamma(00000428)=0.134180517192002E+02 lr_calc_dens: Charge drift due to real space implementation = 0.15125E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 428 z1= 1 -.616583410521796E-04 0.000000000000000E+00 z1= 2 0.155097364532167E-04 0.000000000000000E+00 z1= 3 -.312301739786212E-02 0.000000000000000E+00 alpha(00000428)=0.000000000000000E+00 beta (00000429)=0.129519322744702E+02 gamma(00000429)=0.129519322744702E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.15530E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 429 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000429)=0.000000000000000E+00 beta (00000430)=0.135425937375430E+02 gamma(00000430)=0.135425937375430E+02 lr_calc_dens: Charge drift due to real space implementation = 0.33519E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 430 z1= 1 0.614632160852250E-04 0.000000000000000E+00 z1= 2 -.170418804786128E-04 0.000000000000000E+00 z1= 3 0.389361916866130E-02 0.000000000000000E+00 alpha(00000430)=0.000000000000000E+00 beta (00000431)=0.131368592838798E+02 gamma(00000431)=0.131368592838798E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.15548E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 431 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000431)=0.000000000000000E+00 beta (00000432)=0.134633946693578E+02 gamma(00000432)=0.134633946693578E+02 lr_calc_dens: Charge drift due to real space implementation = -0.66341E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 432 z1= 1 -.626015897377149E-04 0.000000000000000E+00 z1= 2 0.187669452217517E-04 0.000000000000000E+00 z1= 3 -.488302037603676E-02 0.000000000000000E+00 alpha(00000432)=0.000000000000000E+00 beta (00000433)=0.130048322335935E+02 gamma(00000433)=0.130048322335935E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13452E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 433 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000433)=0.000000000000000E+00 beta (00000434)=0.135406924037336E+02 gamma(00000434)=0.135406924037336E+02 lr_calc_dens: Charge drift due to real space implementation = 0.75879E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 434 z1= 1 0.625499680353616E-04 0.000000000000000E+00 z1= 2 -.205610129002464E-04 0.000000000000000E+00 z1= 3 0.563881755272293E-02 0.000000000000000E+00 alpha(00000434)=0.000000000000000E+00 beta (00000435)=0.130892109446148E+02 gamma(00000435)=0.130892109446148E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11055E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 435 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000435)=0.000000000000000E+00 beta (00000436)=0.134680540438603E+02 gamma(00000436)=0.134680540438603E+02 lr_calc_dens: Charge drift due to real space implementation = -0.50968E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 436 z1= 1 -.629953637527612E-04 0.000000000000000E+00 z1= 2 0.228575126358281E-04 0.000000000000000E+00 z1= 3 -.597707813866561E-02 0.000000000000000E+00 alpha(00000436)=0.000000000000000E+00 beta (00000437)=0.128992672767536E+02 gamma(00000437)=0.128992672767536E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13315E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 437 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000437)=0.000000000000000E+00 beta (00000438)=0.134983414154378E+02 gamma(00000438)=0.134983414154378E+02 lr_calc_dens: Charge drift due to real space implementation = 0.55788E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 438 z1= 1 0.615463717723493E-04 0.000000000000000E+00 z1= 2 -.251195130307175E-04 0.000000000000000E+00 z1= 3 0.589254713496831E-02 0.000000000000000E+00 alpha(00000438)=0.000000000000000E+00 beta (00000439)=0.128926434292017E+02 gamma(00000439)=0.128926434292017E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.15413E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 439 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000439)=0.000000000000000E+00 beta (00000440)=0.135320327720223E+02 gamma(00000440)=0.135320327720223E+02 lr_calc_dens: Charge drift due to real space implementation = -0.84011E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 440 z1= 1 -.589490154937021E-04 0.000000000000000E+00 z1= 2 0.275319162952679E-04 0.000000000000000E+00 z1= 3 -.571457594439134E-02 0.000000000000000E+00 alpha(00000440)=0.000000000000000E+00 beta (00000441)=0.130466707382156E+02 gamma(00000441)=0.130466707382156E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13051E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 441 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000441)=0.000000000000000E+00 beta (00000442)=0.135861402356198E+02 gamma(00000442)=0.135861402356198E+02 lr_calc_dens: Charge drift due to real space implementation = 0.78154E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 442 z1= 1 0.564465200202397E-04 0.000000000000000E+00 z1= 2 -.299039894745965E-04 0.000000000000000E+00 z1= 3 0.569721577226510E-02 0.000000000000000E+00 alpha(00000442)=0.000000000000000E+00 beta (00000443)=0.130111479400275E+02 gamma(00000443)=0.130111479400275E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11122E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 443 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000443)=0.000000000000000E+00 beta (00000444)=0.134728214441147E+02 gamma(00000444)=0.134728214441147E+02 lr_calc_dens: Charge drift due to real space implementation = -0.45512E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 444 z1= 1 -.544508764889711E-04 0.000000000000000E+00 z1= 2 0.321992061855211E-04 0.000000000000000E+00 z1= 3 -.592402741154301E-02 0.000000000000000E+00 alpha(00000444)=0.000000000000000E+00 beta (00000445)=0.130032527407981E+02 gamma(00000445)=0.130032527407981E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13918E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 445 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000445)=0.000000000000000E+00 beta (00000446)=0.136147333247553E+02 gamma(00000446)=0.136147333247553E+02 lr_calc_dens: Charge drift due to real space implementation = 0.44717E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 446 z1= 1 0.525085882849861E-04 0.000000000000000E+00 z1= 2 -.339611984390450E-04 0.000000000000000E+00 z1= 3 0.622197485390854E-02 0.000000000000000E+00 alpha(00000446)=0.000000000000000E+00 beta (00000447)=0.130815364401277E+02 gamma(00000447)=0.130815364401277E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.18706E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 447 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000447)=0.000000000000000E+00 beta (00000448)=0.135299464787294E+02 gamma(00000448)=0.135299464787294E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10726E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 448 z1= 1 -.517878281276132E-04 0.000000000000000E+00 z1= 2 0.359105686415958E-04 0.000000000000000E+00 z1= 3 -.672016977028124E-02 0.000000000000000E+00 alpha(00000448)=0.000000000000000E+00 beta (00000449)=0.128720963155780E+02 gamma(00000449)=0.128720963155780E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.17709E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 449 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000449)=0.000000000000000E+00 beta (00000450)=0.136551460763980E+02 gamma(00000450)=0.136551460763980E+02 lr_calc_dens: Charge drift due to real space implementation = 0.15404E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 450 z1= 1 0.503870593860663E-04 0.000000000000000E+00 z1= 2 -.373965511352266E-04 0.000000000000000E+00 z1= 3 0.704973538806372E-02 0.000000000000000E+00 alpha(00000450)=0.000000000000000E+00 beta (00000451)=0.130800182881987E+02 gamma(00000451)=0.130800182881987E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11538E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 451 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000451)=0.000000000000000E+00 beta (00000452)=0.135096610801129E+02 gamma(00000452)=0.135096610801129E+02 lr_calc_dens: Charge drift due to real space implementation = -0.13177E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 452 z1= 1 -.507071264109842E-04 0.000000000000000E+00 z1= 2 0.389069047589233E-04 0.000000000000000E+00 z1= 3 -.740867326632184E-02 0.000000000000000E+00 alpha(00000452)=0.000000000000000E+00 beta (00000453)=0.130183302348618E+02 gamma(00000453)=0.130183302348618E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.82659E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 453 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000453)=0.000000000000000E+00 beta (00000454)=0.136086009028707E+02 gamma(00000454)=0.136086009028707E+02 lr_calc_dens: Charge drift due to real space implementation = 0.76587E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 454 z1= 1 0.511396902079710E-04 0.000000000000000E+00 z1= 2 -.392844859174636E-04 0.000000000000000E+00 z1= 3 0.743992568709218E-02 0.000000000000000E+00 alpha(00000454)=0.000000000000000E+00 beta (00000455)=0.129645099521333E+02 gamma(00000455)=0.129645099521333E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11360E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 455 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000455)=0.000000000000000E+00 beta (00000456)=0.135795241703916E+02 gamma(00000456)=0.135795241703916E+02 lr_calc_dens: Charge drift due to real space implementation = -0.65922E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 456 z1= 1 -.518076136818565E-04 0.000000000000000E+00 z1= 2 0.384613752935666E-04 0.000000000000000E+00 z1= 3 -.739691229656613E-02 0.000000000000000E+00 alpha(00000456)=0.000000000000000E+00 beta (00000457)=0.129122538597143E+02 gamma(00000457)=0.129122538597143E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.15686E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 457 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000457)=0.000000000000000E+00 beta (00000458)=0.134411504936153E+02 gamma(00000458)=0.134411504936153E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11315E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 458 z1= 1 0.527238018467722E-04 0.000000000000000E+00 z1= 2 -.377502435242580E-04 0.000000000000000E+00 z1= 3 0.739740304371160E-02 0.000000000000000E+00 alpha(00000458)=0.000000000000000E+00 beta (00000459)=0.129460571601094E+02 gamma(00000459)=0.129460571601094E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.15436E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 459 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000459)=0.000000000000000E+00 beta (00000460)=0.134655324766154E+02 gamma(00000460)=0.134655324766154E+02 lr_calc_dens: Charge drift due to real space implementation = -0.17831E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 460 z1= 1 -.529885740360669E-04 0.000000000000000E+00 z1= 2 0.365831110703461E-04 0.000000000000000E+00 z1= 3 -.730435308869445E-02 0.000000000000000E+00 alpha(00000460)=0.000000000000000E+00 beta (00000461)=0.129546297741150E+02 gamma(00000461)=0.129546297741150E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.80228E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 461 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000461)=0.000000000000000E+00 beta (00000462)=0.135966212570379E+02 gamma(00000462)=0.135966212570379E+02 lr_calc_dens: Charge drift due to real space implementation = 0.18744E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 462 z1= 1 0.516989291645218E-04 0.000000000000000E+00 z1= 2 -.351106897211224E-04 0.000000000000000E+00 z1= 3 0.694486517892719E-02 0.000000000000000E+00 alpha(00000462)=0.000000000000000E+00 beta (00000463)=0.130351490575717E+02 gamma(00000463)=0.130351490575717E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.18500E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 463 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000463)=0.000000000000000E+00 beta (00000464)=0.134087564119255E+02 gamma(00000464)=0.134087564119255E+02 lr_calc_dens: Charge drift due to real space implementation = -0.97856E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 464 z1= 1 -.504562135961547E-04 0.000000000000000E+00 z1= 2 0.347875516220402E-04 0.000000000000000E+00 z1= 3 -.650851580157677E-02 0.000000000000000E+00 alpha(00000464)=0.000000000000000E+00 beta (00000465)=0.129973003226456E+02 gamma(00000465)=0.129973003226456E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.19256E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 465 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000465)=0.000000000000000E+00 beta (00000466)=0.135824466139817E+02 gamma(00000466)=0.135824466139817E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10570E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 466 z1= 1 0.486893810863146E-04 0.000000000000000E+00 z1= 2 -.341677618689814E-04 0.000000000000000E+00 z1= 3 0.605523815598271E-02 0.000000000000000E+00 alpha(00000466)=0.000000000000000E+00 beta (00000467)=0.130402821014042E+02 gamma(00000467)=0.130402821014042E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.81719E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 467 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000467)=0.000000000000000E+00 beta (00000468)=0.135490265086867E+02 gamma(00000468)=0.135490265086867E+02 lr_calc_dens: Charge drift due to real space implementation = -0.43957E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 468 z1= 1 -.474724990896052E-04 0.000000000000000E+00 z1= 2 0.333909933910356E-04 0.000000000000000E+00 z1= 3 -.601224755098877E-02 0.000000000000000E+00 alpha(00000468)=0.000000000000000E+00 beta (00000469)=0.130168816779538E+02 gamma(00000469)=0.130168816779538E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14287E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 469 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000469)=0.000000000000000E+00 beta (00000470)=0.134260367869370E+02 gamma(00000470)=0.134260367869370E+02 lr_calc_dens: Charge drift due to real space implementation = 0.13932E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 470 z1= 1 0.471321525997160E-04 0.000000000000000E+00 z1= 2 -.327301411317139E-04 0.000000000000000E+00 z1= 3 0.635633417573067E-02 0.000000000000000E+00 alpha(00000470)=0.000000000000000E+00 beta (00000471)=0.129712077363653E+02 gamma(00000471)=0.129712077363653E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10335E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 471 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000471)=0.000000000000000E+00 beta (00000472)=0.135099079655587E+02 gamma(00000472)=0.135099079655587E+02 lr_calc_dens: Charge drift due to real space implementation = -0.19469E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 472 z1= 1 -.466960543119288E-04 0.000000000000000E+00 z1= 2 0.320185551987686E-04 0.000000000000000E+00 z1= 3 -.662374106914890E-02 0.000000000000000E+00 alpha(00000472)=0.000000000000000E+00 beta (00000473)=0.130867185991509E+02 gamma(00000473)=0.130867185991509E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.22659E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 473 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000473)=0.000000000000000E+00 beta (00000474)=0.134174201822488E+02 gamma(00000474)=0.134174201822488E+02 lr_calc_dens: Charge drift due to real space implementation = 0.15528E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 474 z1= 1 0.475867532965017E-04 0.000000000000000E+00 z1= 2 -.315578597018909E-04 0.000000000000000E+00 z1= 3 0.663100171821620E-02 0.000000000000000E+00 alpha(00000474)=0.000000000000000E+00 beta (00000475)=0.130476427079485E+02 gamma(00000475)=0.130476427079485E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.52519E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 475 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000475)=0.000000000000000E+00 beta (00000476)=0.134599270071315E+02 gamma(00000476)=0.134599270071315E+02 lr_calc_dens: Charge drift due to real space implementation = -0.82103E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 476 z1= 1 -.482445771920770E-04 0.000000000000000E+00 z1= 2 0.306929855832791E-04 0.000000000000000E+00 z1= 3 -.609799838966336E-02 0.000000000000000E+00 alpha(00000476)=0.000000000000000E+00 beta (00000477)=0.131471787458123E+02 gamma(00000477)=0.131471787458123E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.37925E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 477 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000477)=0.000000000000000E+00 beta (00000478)=0.135701715884430E+02 gamma(00000478)=0.135701715884430E+02 lr_calc_dens: Charge drift due to real space implementation = 0.50871E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 478 z1= 1 0.484850974873186E-04 0.000000000000000E+00 z1= 2 -.290159602776656E-04 0.000000000000000E+00 z1= 3 0.525210948796816E-02 0.000000000000000E+00 alpha(00000478)=0.000000000000000E+00 beta (00000479)=0.131266558456643E+02 gamma(00000479)=0.131266558456643E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14008E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 479 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000479)=0.000000000000000E+00 beta (00000480)=0.134886863683169E+02 gamma(00000480)=0.134886863683169E+02 lr_calc_dens: Charge drift due to real space implementation = -0.42712E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 480 z1= 1 -.483991075369039E-04 0.000000000000000E+00 z1= 2 0.278845620448524E-04 0.000000000000000E+00 z1= 3 -.434203310805793E-02 0.000000000000000E+00 alpha(00000480)=0.000000000000000E+00 beta (00000481)=0.130104207016958E+02 gamma(00000481)=0.130104207016958E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.16377E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 481 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000481)=0.000000000000000E+00 beta (00000482)=0.134428648734352E+02 gamma(00000482)=0.134428648734352E+02 lr_calc_dens: Charge drift due to real space implementation = 0.73199E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 482 z1= 1 0.483313161421781E-04 0.000000000000000E+00 z1= 2 -.267172234185755E-04 0.000000000000000E+00 z1= 3 0.362671933094626E-02 0.000000000000000E+00 alpha(00000482)=0.000000000000000E+00 beta (00000483)=0.129391335367061E+02 gamma(00000483)=0.129391335367061E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10514E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 483 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000483)=0.000000000000000E+00 beta (00000484)=0.135779115157424E+02 gamma(00000484)=0.135779115157424E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12175E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 484 z1= 1 -.475804838971975E-04 0.000000000000000E+00 z1= 2 0.256483735034381E-04 0.000000000000000E+00 z1= 3 -.322518839119184E-02 0.000000000000000E+00 alpha(00000484)=0.000000000000000E+00 beta (00000485)=0.129842196049344E+02 gamma(00000485)=0.129842196049344E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.73957E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 485 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000485)=0.000000000000000E+00 beta (00000486)=0.135485867399216E+02 gamma(00000486)=0.135485867399216E+02 lr_calc_dens: Charge drift due to real space implementation = 0.86062E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 486 z1= 1 0.471804555272276E-04 0.000000000000000E+00 z1= 2 -.244937532800090E-04 0.000000000000000E+00 z1= 3 0.296813481964639E-02 0.000000000000000E+00 alpha(00000486)=0.000000000000000E+00 beta (00000487)=0.129509974469520E+02 gamma(00000487)=0.129509974469520E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12324E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 487 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000487)=0.000000000000000E+00 beta (00000488)=0.134495537676308E+02 gamma(00000488)=0.134495537676308E+02 lr_calc_dens: Charge drift due to real space implementation = -0.16810E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 488 z1= 1 -.467574246402559E-04 0.000000000000000E+00 z1= 2 0.234101454609614E-04 0.000000000000000E+00 z1= 3 -.277220142604727E-02 0.000000000000000E+00 alpha(00000488)=0.000000000000000E+00 beta (00000489)=0.131680412267050E+02 gamma(00000489)=0.131680412267050E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.87026E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 489 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000489)=0.000000000000000E+00 beta (00000490)=0.133896887310044E+02 gamma(00000490)=0.133896887310044E+02 lr_calc_dens: Charge drift due to real space implementation = 0.14218E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 490 z1= 1 0.469048164341070E-04 0.000000000000000E+00 z1= 2 -.230161912071388E-04 0.000000000000000E+00 z1= 3 0.262428683555485E-02 0.000000000000000E+00 alpha(00000490)=0.000000000000000E+00 beta (00000491)=0.129646175382838E+02 gamma(00000491)=0.129646175382838E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.59262E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 491 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000491)=0.000000000000000E+00 beta (00000492)=0.135535417980491E+02 gamma(00000492)=0.135535417980491E+02 lr_calc_dens: Charge drift due to real space implementation = -0.41386E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 492 z1= 1 -.455332397237708E-04 0.000000000000000E+00 z1= 2 0.224474283168667E-04 0.000000000000000E+00 z1= 3 -.228514960762524E-02 0.000000000000000E+00 alpha(00000492)=0.000000000000000E+00 beta (00000493)=0.130486190600947E+02 gamma(00000493)=0.130486190600947E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.66060E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 493 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000493)=0.000000000000000E+00 beta (00000494)=0.135727268208142E+02 gamma(00000494)=0.135727268208142E+02 lr_calc_dens: Charge drift due to real space implementation = 0.45950E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 494 z1= 1 0.446227036401101E-04 0.000000000000000E+00 z1= 2 -.219651053515948E-04 0.000000000000000E+00 z1= 3 0.175331086501932E-02 0.000000000000000E+00 alpha(00000494)=0.000000000000000E+00 beta (00000495)=0.129664794001397E+02 gamma(00000495)=0.129664794001397E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.73122E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 495 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000495)=0.000000000000000E+00 beta (00000496)=0.134138877424361E+02 gamma(00000496)=0.134138877424361E+02 lr_calc_dens: Charge drift due to real space implementation = -0.35340E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 496 z1= 1 -.439606359245522E-04 0.000000000000000E+00 z1= 2 0.219966828871839E-04 0.000000000000000E+00 z1= 3 -.107987426852241E-02 0.000000000000000E+00 alpha(00000496)=0.000000000000000E+00 beta (00000497)=0.130343416171606E+02 gamma(00000497)=0.130343416171606E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.77597E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 497 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000497)=0.000000000000000E+00 beta (00000498)=0.134552680112421E+02 gamma(00000498)=0.134552680112421E+02 lr_calc_dens: Charge drift due to real space implementation = 0.18071E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 498 z1= 1 0.433159372424360E-04 0.000000000000000E+00 z1= 2 -.219705931219727E-04 0.000000000000000E+00 z1= 3 0.439381850454133E-03 0.000000000000000E+00 alpha(00000498)=0.000000000000000E+00 beta (00000499)=0.131595387269482E+02 gamma(00000499)=0.131595387269482E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.84861E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 499 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000499)=0.000000000000000E+00 beta (00000500)=0.134265369867911E+02 gamma(00000500)=0.134265369867911E+02 lr_calc_dens: Charge drift due to real space implementation = 0.66261E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 500 z1= 1 -.430682144448896E-04 0.000000000000000E+00 z1= 2 0.228519326797542E-04 0.000000000000000E+00 z1= 3 0.804692418666167E-04 0.000000000000000E+00 alpha(00000500)=0.000000000000000E+00 beta (00000501)=0.130128339916376E+02 gamma(00000501)=0.130128339916376E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.83591E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 501 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000501)=0.000000000000000E+00 beta (00000502)=0.135188581055805E+02 gamma(00000502)=0.135188581055805E+02 lr_calc_dens: Charge drift due to real space implementation = -0.22707E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 502 z1= 1 0.420286061075820E-04 0.000000000000000E+00 z1= 2 -.234356959836295E-04 0.000000000000000E+00 z1= 3 -.419813458426069E-03 0.000000000000000E+00 alpha(00000502)=0.000000000000000E+00 beta (00000503)=0.130459456630994E+02 gamma(00000503)=0.130459456630994E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.77403E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 503 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000503)=0.000000000000000E+00 beta (00000504)=0.134237684368397E+02 gamma(00000504)=0.134237684368397E+02 lr_calc_dens: Charge drift due to real space implementation = 0.29859E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 504 z1= 1 -.415921521445684E-04 0.000000000000000E+00 z1= 2 0.246217686993413E-04 0.000000000000000E+00 z1= 3 0.570993913587399E-03 0.000000000000000E+00 alpha(00000504)=0.000000000000000E+00 beta (00000505)=0.130844304051187E+02 gamma(00000505)=0.130844304051187E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.70919E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 505 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000505)=0.000000000000000E+00 beta (00000506)=0.135297970167270E+02 gamma(00000506)=0.135297970167270E+02 lr_calc_dens: Charge drift due to real space implementation = -0.34737E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 506 z1= 1 0.407979712054858E-04 0.000000000000000E+00 z1= 2 -.256798199884745E-04 0.000000000000000E+00 z1= 3 -.521462564835148E-03 0.000000000000000E+00 alpha(00000506)=0.000000000000000E+00 beta (00000507)=0.131200280339558E+02 gamma(00000507)=0.131200280339558E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.56587E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 507 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000507)=0.000000000000000E+00 beta (00000508)=0.134723775702019E+02 gamma(00000508)=0.134723775702019E+02 lr_calc_dens: Charge drift due to real space implementation = 0.19794E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 508 z1= 1 -.402694140782555E-04 0.000000000000000E+00 z1= 2 0.272718106383041E-04 0.000000000000000E+00 z1= 3 0.454935670154050E-03 0.000000000000000E+00 alpha(00000508)=0.000000000000000E+00 beta (00000509)=0.129541583996208E+02 gamma(00000509)=0.129541583996208E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.55311E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 509 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000509)=0.000000000000000E+00 beta (00000510)=0.135694049900043E+02 gamma(00000510)=0.135694049900043E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11215E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 510 z1= 1 0.395519436502521E-04 0.000000000000000E+00 z1= 2 -.287623823560395E-04 0.000000000000000E+00 z1= 3 -.483712143351012E-03 0.000000000000000E+00 alpha(00000510)=0.000000000000000E+00 beta (00000511)=0.130217817897196E+02 gamma(00000511)=0.130217817897196E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.65935E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 511 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000511)=0.000000000000000E+00 beta (00000512)=0.134379541917681E+02 gamma(00000512)=0.134379541917681E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12065E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 512 z1= 1 -.395650983319359E-04 0.000000000000000E+00 z1= 2 0.309367433312901E-04 0.000000000000000E+00 z1= 3 0.589527613157951E-03 0.000000000000000E+00 alpha(00000512)=0.000000000000000E+00 beta (00000513)=0.129513802675791E+02 gamma(00000513)=0.129513802675791E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.70873E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 513 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000513)=0.000000000000000E+00 beta (00000514)=0.134809398273146E+02 gamma(00000514)=0.134809398273146E+02 lr_calc_dens: Charge drift due to real space implementation = 0.23770E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 514 z1= 1 0.393876667126783E-04 0.000000000000000E+00 z1= 2 -.324523259732697E-04 0.000000000000000E+00 z1= 3 -.680670049629115E-03 0.000000000000000E+00 alpha(00000514)=0.000000000000000E+00 beta (00000515)=0.130650228279766E+02 gamma(00000515)=0.130650228279766E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.75101E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 515 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000515)=0.000000000000000E+00 beta (00000516)=0.136126486690432E+02 gamma(00000516)=0.136126486690432E+02 lr_calc_dens: Charge drift due to real space implementation = -0.39307E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 516 z1= 1 -.392085169487114E-04 0.000000000000000E+00 z1= 2 0.334509162001860E-04 0.000000000000000E+00 z1= 3 0.876527786567362E-03 0.000000000000000E+00 alpha(00000516)=0.000000000000000E+00 beta (00000517)=0.129735379492773E+02 gamma(00000517)=0.129735379492773E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10636E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 517 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000517)=0.000000000000000E+00 beta (00000518)=0.135826535754020E+02 gamma(00000518)=0.135826535754020E+02 lr_calc_dens: Charge drift due to real space implementation = 0.17409E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 518 z1= 1 0.386283283491979E-04 0.000000000000000E+00 z1= 2 -.342244641665669E-04 0.000000000000000E+00 z1= 3 -.140485605554797E-02 0.000000000000000E+00 alpha(00000518)=0.000000000000000E+00 beta (00000519)=0.128824472815924E+02 gamma(00000519)=0.128824472815924E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13858E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 519 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000519)=0.000000000000000E+00 beta (00000520)=0.136346550405198E+02 gamma(00000520)=0.136346550405198E+02 lr_calc_dens: Charge drift due to real space implementation = 0.41810E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 520 z1= 1 -.377056805592038E-04 0.000000000000000E+00 z1= 2 0.342511648667780E-04 0.000000000000000E+00 z1= 3 0.230580273394423E-02 0.000000000000000E+00 alpha(00000520)=0.000000000000000E+00 beta (00000521)=0.129177661032575E+02 gamma(00000521)=0.129177661032575E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.14284E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 521 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000521)=0.000000000000000E+00 beta (00000522)=0.136111312425490E+02 gamma(00000522)=0.136111312425490E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11433E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 522 z1= 1 0.372779680086371E-04 0.000000000000000E+00 z1= 2 -.345548452957886E-04 0.000000000000000E+00 z1= 3 -.333536439452726E-02 0.000000000000000E+00 alpha(00000522)=0.000000000000000E+00 beta (00000523)=0.128672323040859E+02 gamma(00000523)=0.128672323040859E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.88403E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 523 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000523)=0.000000000000000E+00 beta (00000524)=0.135604066421289E+02 gamma(00000524)=0.135604066421289E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12768E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 524 z1= 1 -.369503898564655E-04 0.000000000000000E+00 z1= 2 0.347887412691546E-04 0.000000000000000E+00 z1= 3 0.394977170936699E-02 0.000000000000000E+00 alpha(00000524)=0.000000000000000E+00 beta (00000525)=0.130374505422806E+02 gamma(00000525)=0.130374505422806E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.23488E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 525 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000525)=0.000000000000000E+00 beta (00000526)=0.133893933074429E+02 gamma(00000526)=0.133893933074429E+02 lr_calc_dens: Charge drift due to real space implementation = -0.66178E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 526 z1= 1 0.373960847875979E-04 0.000000000000000E+00 z1= 2 -.364619336877777E-04 0.000000000000000E+00 z1= 3 -.401309860009346E-02 0.000000000000000E+00 alpha(00000526)=0.000000000000000E+00 beta (00000527)=0.130987839183761E+02 gamma(00000527)=0.130987839183761E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.22945E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 527 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000527)=0.000000000000000E+00 beta (00000528)=0.133464261596850E+02 gamma(00000528)=0.133464261596850E+02 lr_calc_dens: Charge drift due to real space implementation = -0.13782E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 528 z1= 1 -.373562761531581E-04 0.000000000000000E+00 z1= 2 0.384852281671586E-04 0.000000000000000E+00 z1= 3 0.363511579649332E-02 0.000000000000000E+00 alpha(00000528)=0.000000000000000E+00 beta (00000529)=0.131532601572249E+02 gamma(00000529)=0.131532601572249E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.77961E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 529 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000529)=0.000000000000000E+00 beta (00000530)=0.133541267157838E+02 gamma(00000530)=0.133541267157838E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12753E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 530 z1= 1 0.376719458874882E-04 0.000000000000000E+00 z1= 2 -.397723040264800E-04 0.000000000000000E+00 z1= 3 -.307146030457423E-02 0.000000000000000E+00 alpha(00000530)=0.000000000000000E+00 beta (00000531)=0.130603862569654E+02 gamma(00000531)=0.130603862569654E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.11419E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 531 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000531)=0.000000000000000E+00 beta (00000532)=0.133510555040859E+02 gamma(00000532)=0.133510555040859E+02 lr_calc_dens: Charge drift due to real space implementation = 0.21766E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 532 z1= 1 -.385383839948954E-04 0.000000000000000E+00 z1= 2 0.401650901155370E-04 0.000000000000000E+00 z1= 3 0.274501914931793E-02 0.000000000000000E+00 alpha(00000532)=0.000000000000000E+00 beta (00000533)=0.129937784826356E+02 gamma(00000533)=0.129937784826356E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11988E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 533 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000533)=0.000000000000000E+00 beta (00000534)=0.135323024685037E+02 gamma(00000534)=0.135323024685037E+02 lr_calc_dens: Charge drift due to real space implementation = -0.79466E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 534 z1= 1 0.395291210141403E-04 0.000000000000000E+00 z1= 2 -.399542979825011E-04 0.000000000000000E+00 z1= 3 -.301889775426196E-02 0.000000000000000E+00 alpha(00000534)=0.000000000000000E+00 beta (00000535)=0.129823235122736E+02 gamma(00000535)=0.129823235122736E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13857E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 535 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000535)=0.000000000000000E+00 beta (00000536)=0.134537493169193E+02 gamma(00000536)=0.134537493169193E+02 lr_calc_dens: Charge drift due to real space implementation = 0.36704E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 536 z1= 1 -.411427780494937E-04 0.000000000000000E+00 z1= 2 0.403950924615487E-04 0.000000000000000E+00 z1= 3 0.400642104013663E-02 0.000000000000000E+00 alpha(00000536)=0.000000000000000E+00 beta (00000537)=0.130240847113800E+02 gamma(00000537)=0.130240847113800E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.15599E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 537 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000537)=0.000000000000000E+00 beta (00000538)=0.135815205659237E+02 gamma(00000538)=0.135815205659237E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10048E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 538 z1= 1 0.423007120265605E-04 0.000000000000000E+00 z1= 2 -.404080691862711E-04 0.000000000000000E+00 z1= 3 -.531105594349837E-02 0.000000000000000E+00 alpha(00000538)=0.000000000000000E+00 beta (00000539)=0.131203132695678E+02 gamma(00000539)=0.131203132695678E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13551E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 539 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000539)=0.000000000000000E+00 beta (00000540)=0.135131195688405E+02 gamma(00000540)=0.135131195688405E+02 lr_calc_dens: Charge drift due to real space implementation = 0.17090E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 540 z1= 1 -.437357459731703E-04 0.000000000000000E+00 z1= 2 0.409513192093156E-04 0.000000000000000E+00 z1= 3 0.647477215217644E-02 0.000000000000000E+00 alpha(00000540)=0.000000000000000E+00 beta (00000541)=0.130191628299877E+02 gamma(00000541)=0.130191628299877E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.46870E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 541 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000541)=0.000000000000000E+00 beta (00000542)=0.136481438478595E+02 gamma(00000542)=0.136481438478595E+02 lr_calc_dens: Charge drift due to real space implementation = -0.15186E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 542 z1= 1 0.441531614057130E-04 0.000000000000000E+00 z1= 2 -.397510599579813E-04 0.000000000000000E+00 z1= 3 -.683298202745772E-02 0.000000000000000E+00 alpha(00000542)=0.000000000000000E+00 beta (00000543)=0.130173969697541E+02 gamma(00000543)=0.130173969697541E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.14848E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 543 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000543)=0.000000000000000E+00 beta (00000544)=0.136086838000294E+02 gamma(00000544)=0.136086838000294E+02 lr_calc_dens: Charge drift due to real space implementation = 0.86511E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 544 z1= 1 -.443965648642449E-04 0.000000000000000E+00 z1= 2 0.386000930458556E-04 0.000000000000000E+00 z1= 3 0.653114509761219E-02 0.000000000000000E+00 alpha(00000544)=0.000000000000000E+00 beta (00000545)=0.128425783637325E+02 gamma(00000545)=0.128425783637325E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.22629E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 545 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000545)=0.000000000000000E+00 beta (00000546)=0.136480245351365E+02 gamma(00000546)=0.136480245351365E+02 lr_calc_dens: Charge drift due to real space implementation = -0.31315E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 546 z1= 1 0.442747383419629E-04 0.000000000000000E+00 z1= 2 -.365084711678280E-04 0.000000000000000E+00 z1= 3 -.590546234319611E-02 0.000000000000000E+00 alpha(00000546)=0.000000000000000E+00 beta (00000547)=0.128761906722261E+02 gamma(00000547)=0.128761906722261E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.26282E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 547 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000547)=0.000000000000000E+00 beta (00000548)=0.136401852035488E+02 gamma(00000548)=0.136401852035488E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10358E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 548 z1= 1 -.447343556891229E-04 0.000000000000000E+00 z1= 2 0.352116456631160E-04 0.000000000000000E+00 z1= 3 0.540423129100075E-02 0.000000000000000E+00 alpha(00000548)=0.000000000000000E+00 beta (00000549)=0.128601812805137E+02 gamma(00000549)=0.128601812805137E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.56226E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 549 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000549)=0.000000000000000E+00 beta (00000550)=0.135519778151866E+02 gamma(00000550)=0.135519778151866E+02 lr_calc_dens: Charge drift due to real space implementation = -0.30574E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 550 z1= 1 0.458822664530016E-04 0.000000000000000E+00 z1= 2 -.343075002189212E-04 0.000000000000000E+00 z1= 3 -.517722883916844E-02 0.000000000000000E+00 alpha(00000550)=0.000000000000000E+00 beta (00000551)=0.129107453171025E+02 gamma(00000551)=0.129107453171025E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10218E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 551 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000551)=0.000000000000000E+00 beta (00000552)=0.135129260458987E+02 gamma(00000552)=0.135129260458987E+02 lr_calc_dens: Charge drift due to real space implementation = 0.60788E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 552 z1= 1 -.476582392612477E-04 0.000000000000000E+00 z1= 2 0.341151400788490E-04 0.000000000000000E+00 z1= 3 0.520331050440979E-02 0.000000000000000E+00 alpha(00000552)=0.000000000000000E+00 beta (00000553)=0.129525906527750E+02 gamma(00000553)=0.129525906527750E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.91209E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 553 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000553)=0.000000000000000E+00 beta (00000554)=0.135586445724195E+02 gamma(00000554)=0.135586445724195E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10990E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 554 z1= 1 0.494021485732906E-04 0.000000000000000E+00 z1= 2 -.327388917844243E-04 0.000000000000000E+00 z1= 3 -.514967793311298E-02 0.000000000000000E+00 alpha(00000554)=0.000000000000000E+00 beta (00000555)=0.128333520626930E+02 gamma(00000555)=0.128333520626930E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.21061E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 555 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000555)=0.000000000000000E+00 beta (00000556)=0.135309849656613E+02 gamma(00000556)=0.135309849656613E+02 lr_calc_dens: Charge drift due to real space implementation = 0.80011E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 556 z1= 1 -.507734214624309E-04 0.000000000000000E+00 z1= 2 0.320934515478574E-04 0.000000000000000E+00 z1= 3 0.487302175154571E-02 0.000000000000000E+00 alpha(00000556)=0.000000000000000E+00 beta (00000557)=0.129538636800800E+02 gamma(00000557)=0.129538636800800E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.15511E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 557 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000557)=0.000000000000000E+00 beta (00000558)=0.135771733388079E+02 gamma(00000558)=0.135771733388079E+02 lr_calc_dens: Charge drift due to real space implementation = -0.28068E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 558 z1= 1 0.520304909891624E-04 0.000000000000000E+00 z1= 2 -.313042045217154E-04 0.000000000000000E+00 z1= 3 -.462716423561155E-02 0.000000000000000E+00 alpha(00000558)=0.000000000000000E+00 beta (00000559)=0.129872029945009E+02 gamma(00000559)=0.129872029945009E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.34926E-10 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 559 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000559)=0.000000000000000E+00 beta (00000560)=0.136460276466156E+02 gamma(00000560)=0.136460276466156E+02 lr_calc_dens: Charge drift due to real space implementation = 0.70697E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 560 z1= 1 -.532702896298276E-04 0.000000000000000E+00 z1= 2 0.304297565876409E-04 0.000000000000000E+00 z1= 3 0.448108080385966E-02 0.000000000000000E+00 alpha(00000560)=0.000000000000000E+00 beta (00000561)=0.129183035208326E+02 gamma(00000561)=0.129183035208326E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.29983E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 561 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000561)=0.000000000000000E+00 beta (00000562)=0.136633961564588E+02 gamma(00000562)=0.136633961564588E+02 lr_calc_dens: Charge drift due to real space implementation = -0.13305E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 562 z1= 1 0.540151912633654E-04 0.000000000000000E+00 z1= 2 -.296683202061511E-04 0.000000000000000E+00 z1= 3 -.447107676664219E-02 0.000000000000000E+00 alpha(00000562)=0.000000000000000E+00 beta (00000563)=0.129902597921087E+02 gamma(00000563)=0.129902597921087E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.55995E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 563 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000563)=0.000000000000000E+00 beta (00000564)=0.136009556511986E+02 gamma(00000564)=0.136009556511986E+02 lr_calc_dens: Charge drift due to real space implementation = 0.45267E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 564 z1= 1 -.546229850892822E-04 0.000000000000000E+00 z1= 2 0.288734319995513E-04 0.000000000000000E+00 z1= 3 0.454684926367936E-02 0.000000000000000E+00 alpha(00000564)=0.000000000000000E+00 beta (00000565)=0.128321247184687E+02 gamma(00000565)=0.128321247184687E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.51156E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 565 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000565)=0.000000000000000E+00 beta (00000566)=0.135173030089840E+02 gamma(00000566)=0.135173030089840E+02 lr_calc_dens: Charge drift due to real space implementation = -0.69424E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 566 z1= 1 0.547449484336354E-04 0.000000000000000E+00 z1= 2 -.274485959641632E-04 0.000000000000000E+00 z1= 3 -.433492043821906E-02 0.000000000000000E+00 alpha(00000566)=0.000000000000000E+00 beta (00000567)=0.130307350339471E+02 gamma(00000567)=0.130307350339471E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.24070E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 567 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000567)=0.000000000000000E+00 beta (00000568)=0.136252812468316E+02 gamma(00000568)=0.136252812468316E+02 lr_calc_dens: Charge drift due to real space implementation = 0.69749E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 568 z1= 1 -.553001020433310E-04 0.000000000000000E+00 z1= 2 0.267969943650653E-04 0.000000000000000E+00 z1= 3 0.386118263481000E-02 0.000000000000000E+00 alpha(00000568)=0.000000000000000E+00 beta (00000569)=0.129058352170221E+02 gamma(00000569)=0.129058352170221E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.39991E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 569 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000569)=0.000000000000000E+00 beta (00000570)=0.135203748135609E+02 gamma(00000570)=0.135203748135609E+02 lr_calc_dens: Charge drift due to real space implementation = -0.48474E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 570 z1= 1 0.556601595826421E-04 0.000000000000000E+00 z1= 2 -.255405114189390E-04 0.000000000000000E+00 z1= 3 -.336625463332475E-02 0.000000000000000E+00 alpha(00000570)=0.000000000000000E+00 beta (00000571)=0.129273740121580E+02 gamma(00000571)=0.129273740121580E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.22646E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 571 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000571)=0.000000000000000E+00 beta (00000572)=0.136507633085475E+02 gamma(00000572)=0.136507633085475E+02 lr_calc_dens: Charge drift due to real space implementation = 0.70048E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 572 z1= 1 -.550293517599839E-04 0.000000000000000E+00 z1= 2 0.238101418650106E-04 0.000000000000000E+00 z1= 3 0.302560396524142E-02 0.000000000000000E+00 alpha(00000572)=0.000000000000000E+00 beta (00000573)=0.129143122241078E+02 gamma(00000573)=0.129143122241078E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.57363E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 573 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000573)=0.000000000000000E+00 beta (00000574)=0.135670579988309E+02 gamma(00000574)=0.135670579988309E+02 lr_calc_dens: Charge drift due to real space implementation = 0.25347E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 574 z1= 1 0.538463953141201E-04 0.000000000000000E+00 z1= 2 -.221081805593966E-04 0.000000000000000E+00 z1= 3 -.291310972265987E-02 0.000000000000000E+00 alpha(00000574)=0.000000000000000E+00 beta (00000575)=0.129225395076350E+02 gamma(00000575)=0.129225395076350E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.53335E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 575 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000575)=0.000000000000000E+00 beta (00000576)=0.136831411546537E+02 gamma(00000576)=0.136831411546537E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11897E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 576 z1= 1 -.520450219759205E-04 0.000000000000000E+00 z1= 2 0.208111235923620E-04 0.000000000000000E+00 z1= 3 0.311109473617581E-02 0.000000000000000E+00 alpha(00000576)=0.000000000000000E+00 beta (00000577)=0.129905516311226E+02 gamma(00000577)=0.129905516311226E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.74666E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 577 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000577)=0.000000000000000E+00 beta (00000578)=0.134925891579600E+02 gamma(00000578)=0.134925891579600E+02 lr_calc_dens: Charge drift due to real space implementation = -0.77841E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 578 z1= 1 0.513202987329715E-04 0.000000000000000E+00 z1= 2 -.200234741065295E-04 0.000000000000000E+00 z1= 3 -.342236075893249E-02 0.000000000000000E+00 alpha(00000578)=0.000000000000000E+00 beta (00000579)=0.129950527748559E+02 gamma(00000579)=0.129950527748559E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.26460E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 579 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000579)=0.000000000000000E+00 beta (00000580)=0.135520756480262E+02 gamma(00000580)=0.135520756480262E+02 lr_calc_dens: Charge drift due to real space implementation = 0.94548E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 580 z1= 1 -.504159408121977E-04 0.000000000000000E+00 z1= 2 0.200778195493335E-04 0.000000000000000E+00 z1= 3 0.337369367326158E-02 0.000000000000000E+00 alpha(00000580)=0.000000000000000E+00 beta (00000581)=0.129653956336079E+02 gamma(00000581)=0.129653956336079E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.28200E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 581 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000581)=0.000000000000000E+00 beta (00000582)=0.135724328082709E+02 gamma(00000582)=0.135724328082709E+02 lr_calc_dens: Charge drift due to real space implementation = -0.68768E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 582 z1= 1 0.497564271729365E-04 0.000000000000000E+00 z1= 2 -.209784199890103E-04 0.000000000000000E+00 z1= 3 -.292324989924203E-02 0.000000000000000E+00 alpha(00000582)=0.000000000000000E+00 beta (00000583)=0.129431849192299E+02 gamma(00000583)=0.129431849192299E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.55553E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 583 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000583)=0.000000000000000E+00 beta (00000584)=0.135319212310247E+02 gamma(00000584)=0.135319212310247E+02 lr_calc_dens: Charge drift due to real space implementation = 0.32140E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 584 z1= 1 -.494049304738348E-04 0.000000000000000E+00 z1= 2 0.228443811258316E-04 0.000000000000000E+00 z1= 3 0.231328563672343E-02 0.000000000000000E+00 alpha(00000584)=0.000000000000000E+00 beta (00000585)=0.129194543352389E+02 gamma(00000585)=0.129194543352389E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.55969E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 585 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000585)=0.000000000000000E+00 beta (00000586)=0.135415251105427E+02 gamma(00000586)=0.135415251105427E+02 lr_calc_dens: Charge drift due to real space implementation = -0.13780E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 586 z1= 1 0.486721807750969E-04 0.000000000000000E+00 z1= 2 -.244502669548934E-04 0.000000000000000E+00 z1= 3 -.175191227879013E-02 0.000000000000000E+00 alpha(00000586)=0.000000000000000E+00 beta (00000587)=0.130244729647267E+02 gamma(00000587)=0.130244729647267E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.61058E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 587 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000587)=0.000000000000000E+00 beta (00000588)=0.134791036188475E+02 gamma(00000588)=0.134791036188475E+02 lr_calc_dens: Charge drift due to real space implementation = -0.97584E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 588 z1= 1 -.486418528619829E-04 0.000000000000000E+00 z1= 2 0.259785858870816E-04 0.000000000000000E+00 z1= 3 0.134193741794479E-02 0.000000000000000E+00 alpha(00000588)=0.000000000000000E+00 beta (00000589)=0.130095476309918E+02 gamma(00000589)=0.130095476309918E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.48476E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 589 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000589)=0.000000000000000E+00 beta (00000590)=0.135370007177966E+02 gamma(00000590)=0.135370007177966E+02 lr_calc_dens: Charge drift due to real space implementation = 0.18495E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 590 z1= 1 0.487062747489590E-04 0.000000000000000E+00 z1= 2 -.259084838214369E-04 0.000000000000000E+00 z1= 3 -.112939898877608E-02 0.000000000000000E+00 alpha(00000590)=0.000000000000000E+00 beta (00000591)=0.129569679606716E+02 gamma(00000591)=0.129569679606716E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.22057E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 591 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000591)=0.000000000000000E+00 beta (00000592)=0.135395887272343E+02 gamma(00000592)=0.135395887272343E+02 lr_calc_dens: Charge drift due to real space implementation = 0.40726E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 592 z1= 1 -.488717355420126E-04 0.000000000000000E+00 z1= 2 0.251562453236678E-04 0.000000000000000E+00 z1= 3 0.109717072677109E-02 0.000000000000000E+00 alpha(00000592)=0.000000000000000E+00 beta (00000593)=0.129283402408387E+02 gamma(00000593)=0.129283402408387E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12162E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 593 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000593)=0.000000000000000E+00 beta (00000594)=0.135462218464022E+02 gamma(00000594)=0.135462218464022E+02 lr_calc_dens: Charge drift due to real space implementation = -0.37063E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 594 z1= 1 0.487487333884512E-04 0.000000000000000E+00 z1= 2 -.243499388219625E-04 0.000000000000000E+00 z1= 3 -.116518425996922E-02 0.000000000000000E+00 alpha(00000594)=0.000000000000000E+00 beta (00000595)=0.131102852296166E+02 gamma(00000595)=0.131102852296166E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.22308E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 595 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000595)=0.000000000000000E+00 beta (00000596)=0.135497361994553E+02 gamma(00000596)=0.135497361994553E+02 lr_calc_dens: Charge drift due to real space implementation = 0.74764E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 596 z1= 1 -.493924770126700E-04 0.000000000000000E+00 z1= 2 0.242469315536935E-04 0.000000000000000E+00 z1= 3 0.111795408833132E-02 0.000000000000000E+00 alpha(00000596)=0.000000000000000E+00 beta (00000597)=0.129899539545202E+02 gamma(00000597)=0.129899539545202E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.80166E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 597 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000597)=0.000000000000000E+00 beta (00000598)=0.135432383423868E+02 gamma(00000598)=0.135432383423868E+02 lr_calc_dens: Charge drift due to real space implementation = -0.56908E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 598 z1= 1 0.496660994701145E-04 0.000000000000000E+00 z1= 2 -.237119029421991E-04 0.000000000000000E+00 z1= 3 -.776910624916666E-03 0.000000000000000E+00 alpha(00000598)=0.000000000000000E+00 beta (00000599)=0.130320934202107E+02 gamma(00000599)=0.130320934202107E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12768E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 599 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000599)=0.000000000000000E+00 beta (00000600)=0.134441795959018E+02 gamma(00000600)=0.134441795959018E+02 lr_calc_dens: Charge drift due to real space implementation = 0.38129E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 600 z1= 1 -.499163104519511E-04 0.000000000000000E+00 z1= 2 0.226171341201373E-04 0.000000000000000E+00 z1= 3 0.300204782166138E-03 0.000000000000000E+00 alpha(00000600)=0.000000000000000E+00 beta (00000601)=0.129507419258438E+02 gamma(00000601)=0.129507419258438E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13948E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 601 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000601)=0.000000000000000E+00 beta (00000602)=0.135353539808889E+02 gamma(00000602)=0.135353539808889E+02 lr_calc_dens: Charge drift due to real space implementation = 0.48274E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 602 z1= 1 0.489650913565578E-04 0.000000000000000E+00 z1= 2 -.209815509069893E-04 0.000000000000000E+00 z1= 3 0.174350359223051E-03 0.000000000000000E+00 alpha(00000602)=0.000000000000000E+00 beta (00000603)=0.130318301112877E+02 gamma(00000603)=0.130318301112877E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12642E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 603 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000603)=0.000000000000000E+00 beta (00000604)=0.134731600661282E+02 gamma(00000604)=0.134731600661282E+02 lr_calc_dens: Charge drift due to real space implementation = -0.94772E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 604 z1= 1 -.482941795940382E-04 0.000000000000000E+00 z1= 2 0.202303067719666E-04 0.000000000000000E+00 z1= 3 -.588722562057786E-03 0.000000000000000E+00 alpha(00000604)=0.000000000000000E+00 beta (00000605)=0.128787924594271E+02 gamma(00000605)=0.128787924594271E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.71200E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 605 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000605)=0.000000000000000E+00 beta (00000606)=0.135175615606702E+02 gamma(00000606)=0.135175615606702E+02 lr_calc_dens: Charge drift due to real space implementation = 0.84664E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 606 z1= 1 0.470087654805095E-04 0.000000000000000E+00 z1= 2 -.193100898264633E-04 0.000000000000000E+00 z1= 3 0.641320958491384E-03 0.000000000000000E+00 alpha(00000606)=0.000000000000000E+00 beta (00000607)=0.129994216234251E+02 gamma(00000607)=0.129994216234251E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.14808E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 607 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000607)=0.000000000000000E+00 beta (00000608)=0.135451162961875E+02 gamma(00000608)=0.135451162961875E+02 lr_calc_dens: Charge drift due to real space implementation = -0.13976E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 608 z1= 1 -.462218493545344E-04 0.000000000000000E+00 z1= 2 0.184931873741131E-04 0.000000000000000E+00 z1= 3 -.345630637019267E-03 0.000000000000000E+00 alpha(00000608)=0.000000000000000E+00 beta (00000609)=0.129876628648441E+02 gamma(00000609)=0.129876628648441E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.20778E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 609 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000609)=0.000000000000000E+00 beta (00000610)=0.134477349794125E+02 gamma(00000610)=0.134477349794125E+02 lr_calc_dens: Charge drift due to real space implementation = -0.45931E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 610 z1= 1 0.462547979221193E-04 0.000000000000000E+00 z1= 2 -.175784439572926E-04 0.000000000000000E+00 z1= 3 0.151715357735029E-03 0.000000000000000E+00 alpha(00000610)=0.000000000000000E+00 beta (00000611)=0.130422455810617E+02 gamma(00000611)=0.130422455810617E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.81063E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 611 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000611)=0.000000000000000E+00 beta (00000612)=0.134681279931731E+02 gamma(00000612)=0.134681279931731E+02 lr_calc_dens: Charge drift due to real space implementation = 0.31519E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 612 z1= 1 -.469008741870469E-04 0.000000000000000E+00 z1= 2 0.157678835285671E-04 0.000000000000000E+00 z1= 3 -.352800885558772E-03 0.000000000000000E+00 alpha(00000612)=0.000000000000000E+00 beta (00000613)=0.130384737106884E+02 gamma(00000613)=0.130384737106884E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.11955E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 613 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000613)=0.000000000000000E+00 beta (00000614)=0.135238000927567E+02 gamma(00000614)=0.135238000927567E+02 lr_calc_dens: Charge drift due to real space implementation = 0.14098E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 614 z1= 1 0.476512609305888E-04 0.000000000000000E+00 z1= 2 -.136502462772785E-04 0.000000000000000E+00 z1= 3 0.834741663432607E-03 0.000000000000000E+00 alpha(00000614)=0.000000000000000E+00 beta (00000615)=0.130308522062202E+02 gamma(00000615)=0.130308522062202E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12773E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 615 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000615)=0.000000000000000E+00 beta (00000616)=0.134848227629766E+02 gamma(00000616)=0.134848227629766E+02 lr_calc_dens: Charge drift due to real space implementation = -0.59802E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 616 z1= 1 -.485008086770848E-04 0.000000000000000E+00 z1= 2 0.119720914438490E-04 0.000000000000000E+00 z1= 3 -.146179314937666E-02 0.000000000000000E+00 alpha(00000616)=0.000000000000000E+00 beta (00000617)=0.130345427750148E+02 gamma(00000617)=0.130345427750148E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10578E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 617 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000617)=0.000000000000000E+00 beta (00000618)=0.134223896231656E+02 gamma(00000618)=0.134223896231656E+02 lr_calc_dens: Charge drift due to real space implementation = 0.71593E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 618 z1= 1 0.493949844661786E-04 0.000000000000000E+00 z1= 2 -.113528213339649E-04 0.000000000000000E+00 z1= 3 0.206307593955931E-02 0.000000000000000E+00 alpha(00000618)=0.000000000000000E+00 beta (00000619)=0.129699345872526E+02 gamma(00000619)=0.129699345872526E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.95613E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 619 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000619)=0.000000000000000E+00 beta (00000620)=0.136357253482783E+02 gamma(00000620)=0.136357253482783E+02 lr_calc_dens: Charge drift due to real space implementation = -0.73296E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 620 z1= 1 -.490004222006639E-04 0.000000000000000E+00 z1= 2 0.101661801185885E-04 0.000000000000000E+00 z1= 3 -.230022489612454E-02 0.000000000000000E+00 alpha(00000620)=0.000000000000000E+00 beta (00000621)=0.131077698042141E+02 gamma(00000621)=0.131077698042141E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.93550E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 621 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000621)=0.000000000000000E+00 beta (00000622)=0.135608550319298E+02 gamma(00000622)=0.135608550319298E+02 lr_calc_dens: Charge drift due to real space implementation = 0.83715E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 622 z1= 1 0.493809884221540E-04 0.000000000000000E+00 z1= 2 -.949137002969725E-05 0.000000000000000E+00 z1= 3 0.231436904875069E-02 0.000000000000000E+00 alpha(00000622)=0.000000000000000E+00 beta (00000623)=0.129874547569469E+02 gamma(00000623)=0.129874547569469E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.71441E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 623 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000623)=0.000000000000000E+00 beta (00000624)=0.134841785308947E+02 gamma(00000624)=0.134841785308947E+02 lr_calc_dens: Charge drift due to real space implementation = -0.72543E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 624 z1= 1 -.499372989136297E-04 0.000000000000000E+00 z1= 2 0.832992132319803E-05 0.000000000000000E+00 z1= 3 -.218958165711467E-02 0.000000000000000E+00 alpha(00000624)=0.000000000000000E+00 beta (00000625)=0.129862758390498E+02 gamma(00000625)=0.129862758390498E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.53522E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 625 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000625)=0.000000000000000E+00 beta (00000626)=0.134938185424802E+02 gamma(00000626)=0.134938185424802E+02 lr_calc_dens: Charge drift due to real space implementation = 0.53043E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 626 z1= 1 0.506990109498336E-04 0.000000000000000E+00 z1= 2 -.815226772581157E-05 0.000000000000000E+00 z1= 3 0.200648002012876E-02 0.000000000000000E+00 alpha(00000626)=0.000000000000000E+00 beta (00000627)=0.130213980007213E+02 gamma(00000627)=0.130213980007213E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.43676E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 627 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000627)=0.000000000000000E+00 beta (00000628)=0.135709932810603E+02 gamma(00000628)=0.135709932810603E+02 lr_calc_dens: Charge drift due to real space implementation = -0.32499E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 628 z1= 1 -.514940548426123E-04 0.000000000000000E+00 z1= 2 0.866171302647356E-05 0.000000000000000E+00 z1= 3 -.196270415617087E-02 0.000000000000000E+00 alpha(00000628)=0.000000000000000E+00 beta (00000629)=0.129799643950622E+02 gamma(00000629)=0.129799643950622E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.47878E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 629 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000629)=0.000000000000000E+00 beta (00000630)=0.135181844079951E+02 gamma(00000630)=0.135181844079951E+02 lr_calc_dens: Charge drift due to real space implementation = 0.26293E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 630 z1= 1 0.525659978763755E-04 0.000000000000000E+00 z1= 2 -.105371564339401E-04 0.000000000000000E+00 z1= 3 0.219910675592390E-02 0.000000000000000E+00 alpha(00000630)=0.000000000000000E+00 beta (00000631)=0.129788907910532E+02 gamma(00000631)=0.129788907910532E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.58235E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 631 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000631)=0.000000000000000E+00 beta (00000632)=0.135795627812652E+02 gamma(00000632)=0.135795627812652E+02 lr_calc_dens: Charge drift due to real space implementation = -0.41037E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 632 z1= 1 -.537375593795813E-04 0.000000000000000E+00 z1= 2 0.118244252229632E-04 0.000000000000000E+00 z1= 3 -.256573997550200E-02 0.000000000000000E+00 alpha(00000632)=0.000000000000000E+00 beta (00000633)=0.130029988667005E+02 gamma(00000633)=0.130029988667005E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.58091E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 633 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000633)=0.000000000000000E+00 beta (00000634)=0.134415209110904E+02 gamma(00000634)=0.134415209110904E+02 lr_calc_dens: Charge drift due to real space implementation = 0.65898E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 634 z1= 1 0.555220325383475E-04 0.000000000000000E+00 z1= 2 -.127198125751219E-04 0.000000000000000E+00 z1= 3 0.289904654663549E-02 0.000000000000000E+00 alpha(00000634)=0.000000000000000E+00 beta (00000635)=0.130562920803970E+02 gamma(00000635)=0.130562920803970E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.33725E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 635 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000635)=0.000000000000000E+00 beta (00000636)=0.135102092849105E+02 gamma(00000636)=0.135102092849105E+02 lr_calc_dens: Charge drift due to real space implementation = -0.65603E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 636 z1= 1 -.570663207337481E-04 0.000000000000000E+00 z1= 2 0.142651681189533E-04 0.000000000000000E+00 z1= 3 -.309948953007612E-02 0.000000000000000E+00 alpha(00000636)=0.000000000000000E+00 beta (00000637)=0.130130962398270E+02 gamma(00000637)=0.130130962398270E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14802E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 637 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000637)=0.000000000000000E+00 beta (00000638)=0.134994825705724E+02 gamma(00000638)=0.134994825705724E+02 lr_calc_dens: Charge drift due to real space implementation = 0.40801E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 638 z1= 1 0.580822497882434E-04 0.000000000000000E+00 z1= 2 -.164335071889422E-04 0.000000000000000E+00 z1= 3 0.321304185505367E-02 0.000000000000000E+00 alpha(00000638)=0.000000000000000E+00 beta (00000639)=0.130159396427091E+02 gamma(00000639)=0.130159396427091E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.25447E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 639 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000639)=0.000000000000000E+00 beta (00000640)=0.135002857434287E+02 gamma(00000640)=0.135002857434287E+02 lr_calc_dens: Charge drift due to real space implementation = -0.22142E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 640 z1= 1 -.591829750448537E-04 0.000000000000000E+00 z1= 2 0.190198781453561E-04 0.000000000000000E+00 z1= 3 -.319699012812710E-02 0.000000000000000E+00 alpha(00000640)=0.000000000000000E+00 beta (00000641)=0.129802992461857E+02 gamma(00000641)=0.129802992461857E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.60509E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 641 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000641)=0.000000000000000E+00 beta (00000642)=0.135472257799522E+02 gamma(00000642)=0.135472257799522E+02 lr_calc_dens: Charge drift due to real space implementation = 0.38515E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 642 z1= 1 0.600212373567691E-04 0.000000000000000E+00 z1= 2 -.213852998376021E-04 0.000000000000000E+00 z1= 3 0.292016639460149E-02 0.000000000000000E+00 alpha(00000642)=0.000000000000000E+00 beta (00000643)=0.130835100829023E+02 gamma(00000643)=0.130835100829023E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.77422E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 643 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000643)=0.000000000000000E+00 beta (00000644)=0.135602179134120E+02 gamma(00000644)=0.135602179134120E+02 lr_calc_dens: Charge drift due to real space implementation = -0.72870E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 644 z1= 1 -.612467761609399E-04 0.000000000000000E+00 z1= 2 0.244218126225119E-04 0.000000000000000E+00 z1= 3 -.260815272041920E-02 0.000000000000000E+00 alpha(00000644)=0.000000000000000E+00 beta (00000645)=0.130226120191659E+02 gamma(00000645)=0.130226120191659E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.56007E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 645 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000645)=0.000000000000000E+00 beta (00000646)=0.134934942012480E+02 gamma(00000646)=0.134934942012480E+02 lr_calc_dens: Charge drift due to real space implementation = 0.92999E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 646 z1= 1 0.628276591557279E-04 0.000000000000000E+00 z1= 2 -.279466355108492E-04 0.000000000000000E+00 z1= 3 0.237668712274738E-02 0.000000000000000E+00 alpha(00000646)=0.000000000000000E+00 beta (00000647)=0.130154180672613E+02 gamma(00000647)=0.130154180672613E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.39185E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 647 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000647)=0.000000000000000E+00 beta (00000648)=0.134036155766584E+02 gamma(00000648)=0.134036155766584E+02 lr_calc_dens: Charge drift due to real space implementation = -0.45535E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 648 z1= 1 -.658486086089515E-04 0.000000000000000E+00 z1= 2 0.318639682186809E-04 0.000000000000000E+00 z1= 3 -.223782296480916E-02 0.000000000000000E+00 alpha(00000648)=0.000000000000000E+00 beta (00000649)=0.130485396904519E+02 gamma(00000649)=0.130485396904519E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.16438E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 649 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000649)=0.000000000000000E+00 beta (00000650)=0.134764597126679E+02 gamma(00000650)=0.134764597126679E+02 lr_calc_dens: Charge drift due to real space implementation = -0.66389E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 650 z1= 1 0.693124028855473E-04 0.000000000000000E+00 z1= 2 -.358191453167658E-04 0.000000000000000E+00 z1= 3 0.225942113933881E-02 0.000000000000000E+00 alpha(00000650)=0.000000000000000E+00 beta (00000651)=0.129450457633956E+02 gamma(00000651)=0.129450457633956E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.30172E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 651 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000651)=0.000000000000000E+00 beta (00000652)=0.135123404408098E+02 gamma(00000652)=0.135123404408098E+02 lr_calc_dens: Charge drift due to real space implementation = -0.52243E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 652 z1= 1 -.723541319197483E-04 0.000000000000000E+00 z1= 2 0.392378166323662E-04 0.000000000000000E+00 z1= 3 -.242524680996219E-02 0.000000000000000E+00 alpha(00000652)=0.000000000000000E+00 beta (00000653)=0.130309719777641E+02 gamma(00000653)=0.130309719777641E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.63907E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 653 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000653)=0.000000000000000E+00 beta (00000654)=0.134159947170358E+02 gamma(00000654)=0.134159947170358E+02 lr_calc_dens: Charge drift due to real space implementation = 0.61910E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 654 z1= 1 0.761047119532678E-04 0.000000000000000E+00 z1= 2 -.425683943134066E-04 0.000000000000000E+00 z1= 3 0.276980921580570E-02 0.000000000000000E+00 alpha(00000654)=0.000000000000000E+00 beta (00000655)=0.130370019694679E+02 gamma(00000655)=0.130370019694679E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.38419E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 655 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000655)=0.000000000000000E+00 beta (00000656)=0.135232068968286E+02 gamma(00000656)=0.135232068968286E+02 lr_calc_dens: Charge drift due to real space implementation = -0.94320E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 656 z1= 1 -.791233014223305E-04 0.000000000000000E+00 z1= 2 0.449285502331590E-04 0.000000000000000E+00 z1= 3 -.299131122100733E-02 0.000000000000000E+00 alpha(00000656)=0.000000000000000E+00 beta (00000657)=0.130311871077861E+02 gamma(00000657)=0.130311871077861E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.21108E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 657 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000657)=0.000000000000000E+00 beta (00000658)=0.135768256871309E+02 gamma(00000658)=0.135768256871309E+02 lr_calc_dens: Charge drift due to real space implementation = 0.57242E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 658 z1= 1 0.820058280827090E-04 0.000000000000000E+00 z1= 2 -.467251055389680E-04 0.000000000000000E+00 z1= 3 0.297206623478775E-02 0.000000000000000E+00 alpha(00000658)=0.000000000000000E+00 beta (00000659)=0.130032135704391E+02 gamma(00000659)=0.130032135704391E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.30283E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 659 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000659)=0.000000000000000E+00 beta (00000660)=0.135708967140281E+02 gamma(00000660)=0.135708967140281E+02 lr_calc_dens: Charge drift due to real space implementation = -0.22824E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 660 z1= 1 -.850479189280824E-04 0.000000000000000E+00 z1= 2 0.481570471814579E-04 0.000000000000000E+00 z1= 3 -.287845266081069E-02 0.000000000000000E+00 alpha(00000660)=0.000000000000000E+00 beta (00000661)=0.129539545071863E+02 gamma(00000661)=0.129539545071863E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.92674E-11 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 661 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000661)=0.000000000000000E+00 beta (00000662)=0.134914516616232E+02 gamma(00000662)=0.134914516616232E+02 lr_calc_dens: Charge drift due to real space implementation = 0.31822E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 662 z1= 1 0.884888521969355E-04 0.000000000000000E+00 z1= 2 -.492619379238587E-04 0.000000000000000E+00 z1= 3 0.267911246197952E-02 0.000000000000000E+00 alpha(00000662)=0.000000000000000E+00 beta (00000663)=0.129727152314445E+02 gamma(00000663)=0.129727152314445E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.15097E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 663 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000663)=0.000000000000000E+00 beta (00000664)=0.134788876998125E+02 gamma(00000664)=0.134788876998125E+02 lr_calc_dens: Charge drift due to real space implementation = -0.58081E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 664 z1= 1 -.924648035239479E-04 0.000000000000000E+00 z1= 2 0.499398351567664E-04 0.000000000000000E+00 z1= 3 -.237162152625644E-02 0.000000000000000E+00 alpha(00000664)=0.000000000000000E+00 beta (00000665)=0.129441114757582E+02 gamma(00000665)=0.129441114757582E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.93765E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 665 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000665)=0.000000000000000E+00 beta (00000666)=0.134991147643775E+02 gamma(00000666)=0.134991147643775E+02 lr_calc_dens: Charge drift due to real space implementation = 0.51271E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 666 z1= 1 0.962512837613174E-04 0.000000000000000E+00 z1= 2 -.498104370117717E-04 0.000000000000000E+00 z1= 3 0.192627936013420E-02 0.000000000000000E+00 alpha(00000666)=0.000000000000000E+00 beta (00000667)=0.128898197858571E+02 gamma(00000667)=0.128898197858571E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.34102E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 667 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000667)=0.000000000000000E+00 beta (00000668)=0.135381915880445E+02 gamma(00000668)=0.135381915880445E+02 lr_calc_dens: Charge drift due to real space implementation = -0.23823E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 668 z1= 1 -.990993191264797E-04 0.000000000000000E+00 z1= 2 0.495385785646041E-04 0.000000000000000E+00 z1= 3 -.133733775863917E-02 0.000000000000000E+00 alpha(00000668)=0.000000000000000E+00 beta (00000669)=0.128923548937807E+02 gamma(00000669)=0.128923548937807E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.41186E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 669 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000669)=0.000000000000000E+00 beta (00000670)=0.134561680409445E+02 gamma(00000670)=0.134561680409445E+02 lr_calc_dens: Charge drift due to real space implementation = -0.48860E-10 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 670 z1= 1 0.102222707377196E-03 0.000000000000000E+00 z1= 2 -.494449268187893E-04 0.000000000000000E+00 z1= 3 0.806786898730912E-03 0.000000000000000E+00 alpha(00000670)=0.000000000000000E+00 beta (00000671)=0.130490451884027E+02 gamma(00000671)=0.130490451884027E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.29621E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 671 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000671)=0.000000000000000E+00 beta (00000672)=0.135501267490111E+02 gamma(00000672)=0.135501267490111E+02 lr_calc_dens: Charge drift due to real space implementation = 0.24071E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 672 z1= 1 -.105821111838748E-03 0.000000000000000E+00 z1= 2 0.495856150705144E-04 0.000000000000000E+00 z1= 3 -.379990386907887E-03 0.000000000000000E+00 alpha(00000672)=0.000000000000000E+00 beta (00000673)=0.129478093229546E+02 gamma(00000673)=0.129478093229546E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.20174E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 673 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000673)=0.000000000000000E+00 beta (00000674)=0.135461794626609E+02 gamma(00000674)=0.135461794626609E+02 lr_calc_dens: Charge drift due to real space implementation = 0.17368E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 674 z1= 1 0.108388042174587E-03 0.000000000000000E+00 z1= 2 -.496158375963045E-04 0.000000000000000E+00 z1= 3 0.114771435121427E-03 0.000000000000000E+00 alpha(00000674)=0.000000000000000E+00 beta (00000675)=0.130422216825964E+02 gamma(00000675)=0.130422216825964E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.34607E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 675 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000675)=0.000000000000000E+00 beta (00000676)=0.134497233869257E+02 gamma(00000676)=0.134497233869257E+02 lr_calc_dens: Charge drift due to real space implementation = -0.27605E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 676 z1= 1 -.112503873392400E-03 0.000000000000000E+00 z1= 2 0.505697903339150E-04 0.000000000000000E+00 z1= 3 -.135211730469551E-03 0.000000000000000E+00 alpha(00000676)=0.000000000000000E+00 beta (00000677)=0.128500439472019E+02 gamma(00000677)=0.128500439472019E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.55041E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 677 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000677)=0.000000000000000E+00 beta (00000678)=0.135773220175320E+02 gamma(00000678)=0.135773220175320E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10733E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 678 z1= 1 0.113568720001827E-03 0.000000000000000E+00 z1= 2 -.504096475115591E-04 0.000000000000000E+00 z1= 3 0.249042666197392E-03 0.000000000000000E+00 alpha(00000678)=0.000000000000000E+00 beta (00000679)=0.129122732198222E+02 gamma(00000679)=0.129122732198222E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.42993E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 679 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000679)=0.000000000000000E+00 beta (00000680)=0.134663788819779E+02 gamma(00000680)=0.134663788819779E+02 lr_calc_dens: Charge drift due to real space implementation = -0.60218E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 680 z1= 1 -.116417221836797E-03 0.000000000000000E+00 z1= 2 0.508272409921832E-04 0.000000000000000E+00 z1= 3 -.273981439205722E-03 0.000000000000000E+00 alpha(00000680)=0.000000000000000E+00 beta (00000681)=0.129389183097376E+02 gamma(00000681)=0.129389183097376E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.19050E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 681 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000681)=0.000000000000000E+00 beta (00000682)=0.135575395930552E+02 gamma(00000682)=0.135575395930552E+02 lr_calc_dens: Charge drift due to real space implementation = 0.27460E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 682 z1= 1 0.118193592339081E-03 0.000000000000000E+00 z1= 2 -.510656466871037E-04 0.000000000000000E+00 z1= 3 0.126085619669970E-03 0.000000000000000E+00 alpha(00000682)=0.000000000000000E+00 beta (00000683)=0.129865049668457E+02 gamma(00000683)=0.129865049668457E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.28010E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 683 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000683)=0.000000000000000E+00 beta (00000684)=0.134296660482046E+02 gamma(00000684)=0.134296660482046E+02 lr_calc_dens: Charge drift due to real space implementation = -0.28583E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 684 z1= 1 -.121396780074485E-03 0.000000000000000E+00 z1= 2 0.519572140169497E-04 0.000000000000000E+00 z1= 3 0.209671839507423E-03 0.000000000000000E+00 alpha(00000684)=0.000000000000000E+00 beta (00000685)=0.129528720367794E+02 gamma(00000685)=0.129528720367794E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.40867E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 685 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000685)=0.000000000000000E+00 beta (00000686)=0.135540208089653E+02 gamma(00000686)=0.135540208089653E+02 lr_calc_dens: Charge drift due to real space implementation = 0.23811E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 686 z1= 1 0.122726689240725E-03 0.000000000000000E+00 z1= 2 -.521767868142662E-04 0.000000000000000E+00 z1= 3 -.705253301261428E-03 0.000000000000000E+00 alpha(00000686)=0.000000000000000E+00 beta (00000687)=0.129414737852600E+02 gamma(00000687)=0.129414737852600E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.70693E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 687 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000687)=0.000000000000000E+00 beta (00000688)=0.136362225845832E+02 gamma(00000688)=0.136362225845832E+02 lr_calc_dens: Charge drift due to real space implementation = 0.29102E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 688 z1= 1 -.123643905736588E-03 0.000000000000000E+00 z1= 2 0.522020395232068E-04 0.000000000000000E+00 z1= 3 0.115010132494379E-02 0.000000000000000E+00 alpha(00000688)=0.000000000000000E+00 beta (00000689)=0.129611176355346E+02 gamma(00000689)=0.129611176355346E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.93086E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 689 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000689)=0.000000000000000E+00 beta (00000690)=0.135359616942593E+02 gamma(00000690)=0.135359616942593E+02 lr_calc_dens: Charge drift due to real space implementation = -0.44667E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 690 z1= 1 0.125563864403246E-03 0.000000000000000E+00 z1= 2 -.526266885879780E-04 0.000000000000000E+00 z1= 3 -.140799287190655E-02 0.000000000000000E+00 alpha(00000690)=0.000000000000000E+00 beta (00000691)=0.130217578489731E+02 gamma(00000691)=0.130217578489731E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.81500E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 691 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000691)=0.000000000000000E+00 beta (00000692)=0.134785149145475E+02 gamma(00000692)=0.134785149145475E+02 lr_calc_dens: Charge drift due to real space implementation = 0.76438E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 692 z1= 1 -.128581008606578E-03 0.000000000000000E+00 z1= 2 0.531539742514271E-04 0.000000000000000E+00 z1= 3 0.135859211966291E-02 0.000000000000000E+00 alpha(00000692)=0.000000000000000E+00 beta (00000693)=0.130059919850064E+02 gamma(00000693)=0.130059919850064E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.20841E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 693 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000693)=0.000000000000000E+00 beta (00000694)=0.135087774850219E+02 gamma(00000694)=0.135087774850219E+02 lr_calc_dens: Charge drift due to real space implementation = -0.32107E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 694 z1= 1 0.130254168061534E-03 0.000000000000000E+00 z1= 2 -.539899240154177E-04 0.000000000000000E+00 z1= 3 -.941720117980794E-03 0.000000000000000E+00 alpha(00000694)=0.000000000000000E+00 beta (00000695)=0.129737231672711E+02 gamma(00000695)=0.129737231672711E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.47943E-10 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 695 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000695)=0.000000000000000E+00 beta (00000696)=0.135365465641038E+02 gamma(00000696)=0.135365465641038E+02 lr_calc_dens: Charge drift due to real space implementation = -0.25559E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 696 z1= 1 -.131411136550823E-03 0.000000000000000E+00 z1= 2 0.549704056274449E-04 0.000000000000000E+00 z1= 3 0.531898194522506E-03 0.000000000000000E+00 alpha(00000696)=0.000000000000000E+00 beta (00000697)=0.130641972650743E+02 gamma(00000697)=0.130641972650743E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.27443E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 697 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000697)=0.000000000000000E+00 beta (00000698)=0.135369885457502E+02 gamma(00000698)=0.135369885457502E+02 lr_calc_dens: Charge drift due to real space implementation = 0.39987E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 698 z1= 1 0.132886323614069E-03 0.000000000000000E+00 z1= 2 -.556488189256887E-04 0.000000000000000E+00 z1= 3 -.485532572133715E-03 0.000000000000000E+00 alpha(00000698)=0.000000000000000E+00 beta (00000699)=0.128750933840876E+02 gamma(00000699)=0.128750933840876E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.48180E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 699 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000699)=0.000000000000000E+00 beta (00000700)=0.134937442418154E+02 gamma(00000700)=0.134937442418154E+02 lr_calc_dens: Charge drift due to real space implementation = -0.35593E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 700 z1= 1 -.133563800916529E-03 0.000000000000000E+00 z1= 2 0.560881174558826E-04 0.000000000000000E+00 z1= 3 0.909277549247322E-03 0.000000000000000E+00 alpha(00000700)=0.000000000000000E+00 beta (00000701)=0.131051980647886E+02 gamma(00000701)=0.131051980647886E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.66340E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 701 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000701)=0.000000000000000E+00 beta (00000702)=0.135331020197909E+02 gamma(00000702)=0.135331020197909E+02 lr_calc_dens: Charge drift due to real space implementation = 0.20083E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 702 z1= 1 0.136307410873739E-03 0.000000000000000E+00 z1= 2 -.567732841772994E-04 0.000000000000000E+00 z1= 3 -.171218164903018E-02 0.000000000000000E+00 alpha(00000702)=0.000000000000000E+00 beta (00000703)=0.130276301843898E+02 gamma(00000703)=0.130276301843898E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.94871E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 703 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000703)=0.000000000000000E+00 beta (00000704)=0.136232430924392E+02 gamma(00000704)=0.136232430924392E+02 lr_calc_dens: Charge drift due to real space implementation = 0.27246E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 704 z1= 1 -.138204176673218E-03 0.000000000000000E+00 z1= 2 0.568118255515355E-04 0.000000000000000E+00 z1= 3 0.267949877473212E-02 0.000000000000000E+00 alpha(00000704)=0.000000000000000E+00 beta (00000705)=0.129735669964874E+02 gamma(00000705)=0.129735669964874E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.91331E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 705 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000705)=0.000000000000000E+00 beta (00000706)=0.135207176614737E+02 gamma(00000706)=0.135207176614737E+02 lr_calc_dens: Charge drift due to real space implementation = -0.62903E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 706 z1= 1 0.140589870898853E-03 0.000000000000000E+00 z1= 2 -.561401491877196E-04 0.000000000000000E+00 z1= 3 -.356612228631906E-02 0.000000000000000E+00 alpha(00000706)=0.000000000000000E+00 beta (00000707)=0.130316884842700E+02 gamma(00000707)=0.130316884842700E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.65566E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 707 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000707)=0.000000000000000E+00 beta (00000708)=0.134920452988901E+02 gamma(00000708)=0.134920452988901E+02 lr_calc_dens: Charge drift due to real space implementation = 0.57825E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 708 z1= 1 -.144096612128344E-03 0.000000000000000E+00 z1= 2 0.563168911010012E-04 0.000000000000000E+00 z1= 3 0.402922279110699E-02 0.000000000000000E+00 alpha(00000708)=0.000000000000000E+00 beta (00000709)=0.129762175708320E+02 gamma(00000709)=0.129762175708320E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.58217E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 709 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000709)=0.000000000000000E+00 beta (00000710)=0.135517312726929E+02 gamma(00000710)=0.135517312726929E+02 lr_calc_dens: Charge drift due to real space implementation = -0.36589E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 710 z1= 1 0.145305221012537E-03 0.000000000000000E+00 z1= 2 -.553630068542123E-04 0.000000000000000E+00 z1= 3 -.414914317702706E-02 0.000000000000000E+00 alpha(00000710)=0.000000000000000E+00 beta (00000711)=0.129032598583761E+02 gamma(00000711)=0.129032598583761E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.81110E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 711 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000711)=0.000000000000000E+00 beta (00000712)=0.135533286920578E+02 gamma(00000712)=0.135533286920578E+02 lr_calc_dens: Charge drift due to real space implementation = 0.45245E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 712 z1= 1 -.145724943384065E-03 0.000000000000000E+00 z1= 2 0.543038382634022E-04 0.000000000000000E+00 z1= 3 0.418663107229973E-02 0.000000000000000E+00 alpha(00000712)=0.000000000000000E+00 beta (00000713)=0.129765393302898E+02 gamma(00000713)=0.129765393302898E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.80219E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 713 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000713)=0.000000000000000E+00 beta (00000714)=0.134265002894524E+02 gamma(00000714)=0.134265002894524E+02 lr_calc_dens: Charge drift due to real space implementation = -0.51321E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 714 z1= 1 0.147753801139916E-03 0.000000000000000E+00 z1= 2 -.528155445578541E-04 0.000000000000000E+00 z1= 3 -.419442088828911E-02 0.000000000000000E+00 alpha(00000714)=0.000000000000000E+00 beta (00000715)=0.130773858897230E+02 gamma(00000715)=0.130773858897230E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.50313E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 715 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000715)=0.000000000000000E+00 beta (00000716)=0.135889100364320E+02 gamma(00000716)=0.135889100364320E+02 lr_calc_dens: Charge drift due to real space implementation = 0.22431E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 716 z1= 1 -.149324884980521E-03 0.000000000000000E+00 z1= 2 0.520233939193009E-04 0.000000000000000E+00 z1= 3 0.409977222273170E-02 0.000000000000000E+00 alpha(00000716)=0.000000000000000E+00 beta (00000717)=0.130075194974498E+02 gamma(00000717)=0.130075194974498E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.43025E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 717 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000717)=0.000000000000000E+00 beta (00000718)=0.135392483717755E+02 gamma(00000718)=0.135392483717755E+02 lr_calc_dens: Charge drift due to real space implementation = 0.68113E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 718 z1= 1 0.150914994381367E-03 0.000000000000000E+00 z1= 2 -.515730712179376E-04 0.000000000000000E+00 z1= 3 -.403355968421717E-02 0.000000000000000E+00 alpha(00000718)=0.000000000000000E+00 beta (00000719)=0.130650987301131E+02 gamma(00000719)=0.130650987301131E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.70456E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 719 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000719)=0.000000000000000E+00 beta (00000720)=0.134968643064473E+02 gamma(00000720)=0.134968643064473E+02 lr_calc_dens: Charge drift due to real space implementation = 0.72666E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 720 z1= 1 -.154212601350610E-03 0.000000000000000E+00 z1= 2 0.526214305903787E-04 0.000000000000000E+00 z1= 3 0.422235976216352E-02 0.000000000000000E+00 alpha(00000720)=0.000000000000000E+00 beta (00000721)=0.129195509457336E+02 gamma(00000721)=0.129195509457336E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.91769E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 721 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000721)=0.000000000000000E+00 beta (00000722)=0.134964060813092E+02 gamma(00000722)=0.134964060813092E+02 lr_calc_dens: Charge drift due to real space implementation = -0.46234E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 722 z1= 1 0.154706541196683E-03 0.000000000000000E+00 z1= 2 -.531554786301494E-04 0.000000000000000E+00 z1= 3 -.465482042505821E-02 0.000000000000000E+00 alpha(00000722)=0.000000000000000E+00 beta (00000723)=0.131147201259287E+02 gamma(00000723)=0.131147201259287E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.87597E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 723 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000723)=0.000000000000000E+00 beta (00000724)=0.134675557833508E+02 gamma(00000724)=0.134675557833508E+02 lr_calc_dens: Charge drift due to real space implementation = 0.81932E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 724 z1= 1 -.157085132434282E-03 0.000000000000000E+00 z1= 2 0.548268790978731E-04 0.000000000000000E+00 z1= 3 0.530614068968224E-02 0.000000000000000E+00 alpha(00000724)=0.000000000000000E+00 beta (00000725)=0.129695418580460E+02 gamma(00000725)=0.129695418580460E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.69474E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 725 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000725)=0.000000000000000E+00 beta (00000726)=0.135594301230535E+02 gamma(00000726)=0.135594301230535E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10110E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 726 z1= 1 0.155624267129631E-03 0.000000000000000E+00 z1= 2 -.549376762827773E-04 0.000000000000000E+00 z1= 3 -.574853411364728E-02 0.000000000000000E+00 alpha(00000726)=0.000000000000000E+00 beta (00000727)=0.130882078064008E+02 gamma(00000727)=0.130882078064008E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.45411E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 727 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000727)=0.000000000000000E+00 beta (00000728)=0.135220951054299E+02 gamma(00000728)=0.135220951054299E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10193E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 728 z1= 1 -.156680285381321E-03 0.000000000000000E+00 z1= 2 0.553849468917472E-04 0.000000000000000E+00 z1= 3 0.591155379788417E-02 0.000000000000000E+00 alpha(00000728)=0.000000000000000E+00 beta (00000729)=0.128936552210872E+02 gamma(00000729)=0.128936552210872E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12390E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 729 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000729)=0.000000000000000E+00 beta (00000730)=0.135408781223056E+02 gamma(00000730)=0.135408781223056E+02 lr_calc_dens: Charge drift due to real space implementation = -0.61917E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 730 z1= 1 0.154916821030490E-03 0.000000000000000E+00 z1= 2 -.552044015805953E-04 0.000000000000000E+00 z1= 3 -.559475820216602E-02 0.000000000000000E+00 alpha(00000730)=0.000000000000000E+00 beta (00000731)=0.130649232171962E+02 gamma(00000731)=0.130649232171962E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.89675E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 731 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000731)=0.000000000000000E+00 beta (00000732)=0.134652689425260E+02 gamma(00000732)=0.134652689425260E+02 lr_calc_dens: Charge drift due to real space implementation = 0.30119E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 732 z1= 1 -.156059032924866E-03 0.000000000000000E+00 z1= 2 0.556369956923707E-04 0.000000000000000E+00 z1= 3 0.530450799798161E-02 0.000000000000000E+00 alpha(00000732)=0.000000000000000E+00 beta (00000733)=0.131130013811654E+02 gamma(00000733)=0.131130013811654E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.96666E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 733 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000733)=0.000000000000000E+00 beta (00000734)=0.135934295824246E+02 gamma(00000734)=0.135934295824246E+02 lr_calc_dens: Charge drift due to real space implementation = 0.75261E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 734 z1= 1 0.155270303988222E-03 0.000000000000000E+00 z1= 2 -.558952233834125E-04 0.000000000000000E+00 z1= 3 -.514627468932853E-02 0.000000000000000E+00 alpha(00000734)=0.000000000000000E+00 beta (00000735)=0.130622461945658E+02 gamma(00000735)=0.130622461945658E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.43768E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 735 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000735)=0.000000000000000E+00 beta (00000736)=0.134714267787548E+02 gamma(00000736)=0.134714267787548E+02 lr_calc_dens: Charge drift due to real space implementation = -0.59870E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 736 z1= 1 -.155492972157966E-03 0.000000000000000E+00 z1= 2 0.553177211947853E-04 0.000000000000000E+00 z1= 3 0.517358927008358E-02 0.000000000000000E+00 alpha(00000736)=0.000000000000000E+00 beta (00000737)=0.129762845080035E+02 gamma(00000737)=0.129762845080035E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.75123E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 737 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000737)=0.000000000000000E+00 beta (00000738)=0.135332873639743E+02 gamma(00000738)=0.135332873639743E+02 lr_calc_dens: Charge drift due to real space implementation = -0.29648E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 738 z1= 1 0.154173058822864E-03 0.000000000000000E+00 z1= 2 -.547068134127269E-04 0.000000000000000E+00 z1= 3 -.536779737341654E-02 0.000000000000000E+00 alpha(00000738)=0.000000000000000E+00 beta (00000739)=0.129509165141342E+02 gamma(00000739)=0.129509165141342E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.89852E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 739 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000739)=0.000000000000000E+00 beta (00000740)=0.135477068049566E+02 gamma(00000740)=0.135477068049566E+02 lr_calc_dens: Charge drift due to real space implementation = 0.90026E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 740 z1= 1 -.153617662507457E-03 0.000000000000000E+00 z1= 2 0.533333815627306E-04 0.000000000000000E+00 z1= 3 0.557996076216124E-02 0.000000000000000E+00 alpha(00000740)=0.000000000000000E+00 beta (00000741)=0.131223135231300E+02 gamma(00000741)=0.131223135231300E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.53817E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 741 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000741)=0.000000000000000E+00 beta (00000742)=0.134530135473875E+02 gamma(00000742)=0.134530135473875E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11793E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 742 z1= 1 0.156066572144907E-03 0.000000000000000E+00 z1= 2 -.531266418636121E-04 0.000000000000000E+00 z1= 3 -.566400478131914E-02 0.000000000000000E+00 alpha(00000742)=0.000000000000000E+00 beta (00000743)=0.129404727073657E+02 gamma(00000743)=0.129404727073657E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.72278E-10 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 743 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000743)=0.000000000000000E+00 beta (00000744)=0.135135259478027E+02 gamma(00000744)=0.135135259478027E+02 lr_calc_dens: Charge drift due to real space implementation = 0.94990E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 744 z1= 1 -.156389844375093E-03 0.000000000000000E+00 z1= 2 0.520026586843620E-04 0.000000000000000E+00 z1= 3 0.534538148067066E-02 0.000000000000000E+00 alpha(00000744)=0.000000000000000E+00 beta (00000745)=0.130412795387385E+02 gamma(00000745)=0.130412795387385E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.27432E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 745 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000745)=0.000000000000000E+00 beta (00000746)=0.135032656102110E+02 gamma(00000746)=0.135032656102110E+02 lr_calc_dens: Charge drift due to real space implementation = -0.58623E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 746 z1= 1 0.157752080577638E-03 0.000000000000000E+00 z1= 2 -.524349124520310E-04 0.000000000000000E+00 z1= 3 -.490588430813764E-02 0.000000000000000E+00 alpha(00000746)=0.000000000000000E+00 beta (00000747)=0.129317103310245E+02 gamma(00000747)=0.129317103310245E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.29792E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 747 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000747)=0.000000000000000E+00 beta (00000748)=0.135447854883795E+02 gamma(00000748)=0.135447854883795E+02 lr_calc_dens: Charge drift due to real space implementation = 0.35825E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 748 z1= 1 -.157283383883066E-03 0.000000000000000E+00 z1= 2 0.523242298818017E-04 0.000000000000000E+00 z1= 3 0.433276342645840E-02 0.000000000000000E+00 alpha(00000748)=0.000000000000000E+00 beta (00000749)=0.130053683732549E+02 gamma(00000749)=0.130053683732549E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.49391E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 749 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000749)=0.000000000000000E+00 beta (00000750)=0.135115045790449E+02 gamma(00000750)=0.135115045790449E+02 lr_calc_dens: Charge drift due to real space implementation = 0.14820E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 750 z1= 1 0.157792097664016E-03 0.000000000000000E+00 z1= 2 -.535204868079556E-04 0.000000000000000E+00 z1= 3 -.365751527463692E-02 0.000000000000000E+00 alpha(00000750)=0.000000000000000E+00 beta (00000751)=0.131101646030117E+02 gamma(00000751)=0.131101646030117E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.37855E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 751 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000751)=0.000000000000000E+00 beta (00000752)=0.135183925116694E+02 gamma(00000752)=0.135183925116694E+02 lr_calc_dens: Charge drift due to real space implementation = -0.61011E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 752 z1= 1 -.159785942250889E-03 0.000000000000000E+00 z1= 2 0.551551244634727E-04 0.000000000000000E+00 z1= 3 0.303499521507657E-02 0.000000000000000E+00 alpha(00000752)=0.000000000000000E+00 beta (00000753)=0.130824137042373E+02 gamma(00000753)=0.130824137042373E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.23865E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 753 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000753)=0.000000000000000E+00 beta (00000754)=0.134627929280320E+02 gamma(00000754)=0.134627929280320E+02 lr_calc_dens: Charge drift due to real space implementation = 0.37157E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 754 z1= 1 0.161760666176655E-03 0.000000000000000E+00 z1= 2 -.581933786501646E-04 0.000000000000000E+00 z1= 3 -.271611967664588E-02 0.000000000000000E+00 alpha(00000754)=0.000000000000000E+00 beta (00000755)=0.130321380385767E+02 gamma(00000755)=0.130321380385767E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.69228E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 755 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000755)=0.000000000000000E+00 beta (00000756)=0.135467689505412E+02 gamma(00000756)=0.135467689505412E+02 lr_calc_dens: Charge drift due to real space implementation = 0.32684E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 756 z1= 1 -.162422261711093E-03 0.000000000000000E+00 z1= 2 0.608367268423309E-04 0.000000000000000E+00 z1= 3 0.265573834109447E-02 0.000000000000000E+00 alpha(00000756)=0.000000000000000E+00 beta (00000757)=0.129427361236423E+02 gamma(00000757)=0.129427361236423E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.57745E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 757 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000757)=0.000000000000000E+00 beta (00000758)=0.135134222739133E+02 gamma(00000758)=0.135134222739133E+02 lr_calc_dens: Charge drift due to real space implementation = -0.80387E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 758 z1= 1 0.162836309488490E-03 0.000000000000000E+00 z1= 2 -.637113077909910E-04 0.000000000000000E+00 z1= 3 -.267952151377465E-02 0.000000000000000E+00 alpha(00000758)=0.000000000000000E+00 beta (00000759)=0.129631192524495E+02 gamma(00000759)=0.129631192524495E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.20805E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 759 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000759)=0.000000000000000E+00 beta (00000760)=0.135475797239897E+02 gamma(00000760)=0.135475797239897E+02 lr_calc_dens: Charge drift due to real space implementation = 0.89455E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 760 z1= 1 -.163586636153251E-03 0.000000000000000E+00 z1= 2 0.671064667588654E-04 0.000000000000000E+00 z1= 3 0.273972937178316E-02 0.000000000000000E+00 alpha(00000760)=0.000000000000000E+00 beta (00000761)=0.128988271852244E+02 gamma(00000761)=0.128988271852244E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10960E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 761 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000761)=0.000000000000000E+00 beta (00000762)=0.134065510934071E+02 gamma(00000762)=0.134065510934071E+02 lr_calc_dens: Charge drift due to real space implementation = -0.73671E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 762 z1= 1 0.165447914823664E-03 0.000000000000000E+00 z1= 2 -.705054026610196E-04 0.000000000000000E+00 z1= 3 -.271538696152265E-02 0.000000000000000E+00 alpha(00000762)=0.000000000000000E+00 beta (00000763)=0.129439450686940E+02 gamma(00000763)=0.129439450686940E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.37739E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 763 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000763)=0.000000000000000E+00 beta (00000764)=0.134088347964000E+02 gamma(00000764)=0.134088347964000E+02 lr_calc_dens: Charge drift due to real space implementation = 0.31901E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 764 z1= 1 -.168809710435848E-03 0.000000000000000E+00 z1= 2 0.730779137310011E-04 0.000000000000000E+00 z1= 3 0.239565285508808E-02 0.000000000000000E+00 alpha(00000764)=0.000000000000000E+00 beta (00000765)=0.130488550066397E+02 gamma(00000765)=0.130488550066397E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.42497E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 765 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000765)=0.000000000000000E+00 beta (00000766)=0.134725350817027E+02 gamma(00000766)=0.134725350817027E+02 lr_calc_dens: Charge drift due to real space implementation = 0.61973E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 766 z1= 1 0.173022849906438E-03 0.000000000000000E+00 z1= 2 -.751656629362345E-04 0.000000000000000E+00 z1= 3 -.179349089614771E-02 0.000000000000000E+00 alpha(00000766)=0.000000000000000E+00 beta (00000767)=0.129838700011299E+02 gamma(00000767)=0.129838700011299E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.36792E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 767 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000767)=0.000000000000000E+00 beta (00000768)=0.135166150614581E+02 gamma(00000768)=0.135166150614581E+02 lr_calc_dens: Charge drift due to real space implementation = -0.29625E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 768 z1= 1 -.175770766572172E-03 0.000000000000000E+00 z1= 2 0.753499537365445E-04 0.000000000000000E+00 z1= 3 0.112009729701332E-02 0.000000000000000E+00 alpha(00000768)=0.000000000000000E+00 beta (00000769)=0.130192022045467E+02 gamma(00000769)=0.130192022045467E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.32461E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 769 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000769)=0.000000000000000E+00 beta (00000770)=0.136217039933266E+02 gamma(00000770)=0.136217039933266E+02 lr_calc_dens: Charge drift due to real space implementation = 0.48193E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 770 z1= 1 0.177197000796876E-03 0.000000000000000E+00 z1= 2 -.760384845182030E-04 0.000000000000000E+00 z1= 3 -.705734047992970E-03 0.000000000000000E+00 alpha(00000770)=0.000000000000000E+00 beta (00000771)=0.129606289771972E+02 gamma(00000771)=0.129606289771972E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.73414E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 771 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000771)=0.000000000000000E+00 beta (00000772)=0.136278307718432E+02 gamma(00000772)=0.136278307718432E+02 lr_calc_dens: Charge drift due to real space implementation = -0.39602E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 772 z1= 1 -.177753799169615E-03 0.000000000000000E+00 z1= 2 0.758952198680624E-04 0.000000000000000E+00 z1= 3 0.595082040333622E-03 0.000000000000000E+00 alpha(00000772)=0.000000000000000E+00 beta (00000773)=0.129296706888935E+02 gamma(00000773)=0.129296706888935E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.31531E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 773 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000773)=0.000000000000000E+00 beta (00000774)=0.135652536213820E+02 gamma(00000774)=0.135652536213820E+02 lr_calc_dens: Charge drift due to real space implementation = -0.17496E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 774 z1= 1 0.178647863282489E-03 0.000000000000000E+00 z1= 2 -.771965869200469E-04 0.000000000000000E+00 z1= 3 -.659900255477294E-03 0.000000000000000E+00 alpha(00000774)=0.000000000000000E+00 beta (00000775)=0.129498651460047E+02 gamma(00000775)=0.129498651460047E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.29316E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 775 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000775)=0.000000000000000E+00 beta (00000776)=0.135710752698764E+02 gamma(00000776)=0.135710752698764E+02 lr_calc_dens: Charge drift due to real space implementation = 0.67771E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 776 z1= 1 -.180085471596877E-03 0.000000000000000E+00 z1= 2 0.776334450514021E-04 0.000000000000000E+00 z1= 3 0.848253447726842E-03 0.000000000000000E+00 alpha(00000776)=0.000000000000000E+00 beta (00000777)=0.130269508330100E+02 gamma(00000777)=0.130269508330100E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.55141E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 777 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000777)=0.000000000000000E+00 beta (00000778)=0.135111174076905E+02 gamma(00000778)=0.135111174076905E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10022E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 778 z1= 1 0.183406073559041E-03 0.000000000000000E+00 z1= 2 -.783709356604804E-04 0.000000000000000E+00 z1= 3 -.945059465871319E-03 0.000000000000000E+00 alpha(00000778)=0.000000000000000E+00 beta (00000779)=0.130186971106576E+02 gamma(00000779)=0.130186971106576E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.46459E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 779 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000779)=0.000000000000000E+00 beta (00000780)=0.134723444646988E+02 gamma(00000780)=0.134723444646988E+02 lr_calc_dens: Charge drift due to real space implementation = 0.84320E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 780 z1= 1 -.187812861445012E-03 0.000000000000000E+00 z1= 2 0.783587347766561E-04 0.000000000000000E+00 z1= 3 0.623412443080312E-03 0.000000000000000E+00 alpha(00000780)=0.000000000000000E+00 beta (00000781)=0.129596415975501E+02 gamma(00000781)=0.129596415975501E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10981E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 781 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000781)=0.000000000000000E+00 beta (00000782)=0.134901122100230E+02 gamma(00000782)=0.134901122100230E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12326E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 782 z1= 1 0.191727088419805E-03 0.000000000000000E+00 z1= 2 -.779853272442736E-04 0.000000000000000E+00 z1= 3 0.247680893920691E-03 0.000000000000000E+00 alpha(00000782)=0.000000000000000E+00 beta (00000783)=0.130658701153042E+02 gamma(00000783)=0.130658701153042E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.83422E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 783 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000783)=0.000000000000000E+00 beta (00000784)=0.134655949360373E+02 gamma(00000784)=0.134655949360373E+02 lr_calc_dens: Charge drift due to real space implementation = -0.68777E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 784 z1= 1 -.198269205071220E-03 0.000000000000000E+00 z1= 2 0.771181210661496E-04 0.000000000000000E+00 z1= 3 -.133239583721699E-02 0.000000000000000E+00 alpha(00000784)=0.000000000000000E+00 beta (00000785)=0.130680441281676E+02 gamma(00000785)=0.130680441281676E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.24487E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 785 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000785)=0.000000000000000E+00 beta (00000786)=0.134898061121535E+02 gamma(00000786)=0.134898061121535E+02 lr_calc_dens: Charge drift due to real space implementation = 0.62557E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 786 z1= 1 0.204317038674018E-03 0.000000000000000E+00 z1= 2 -.768997810032273E-04 0.000000000000000E+00 z1= 3 0.206789092785336E-02 0.000000000000000E+00 alpha(00000786)=0.000000000000000E+00 beta (00000787)=0.129481369491277E+02 gamma(00000787)=0.129481369491277E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.20444E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 787 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000787)=0.000000000000000E+00 beta (00000788)=0.134296243872676E+02 gamma(00000788)=0.134296243872676E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10474E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 788 z1= 1 -.209681682737361E-03 0.000000000000000E+00 z1= 2 0.751590455237612E-04 0.000000000000000E+00 z1= 3 -.211634189565286E-02 0.000000000000000E+00 alpha(00000788)=0.000000000000000E+00 beta (00000789)=0.131792408441210E+02 gamma(00000789)=0.131792408441210E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.90001E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 789 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000789)=0.000000000000000E+00 beta (00000790)=0.134423010762280E+02 gamma(00000790)=0.134423010762280E+02 lr_calc_dens: Charge drift due to real space implementation = -0.23884E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 790 z1= 1 0.217427626649091E-03 0.000000000000000E+00 z1= 2 -.764314800841674E-04 0.000000000000000E+00 z1= 3 0.178970583235880E-02 0.000000000000000E+00 alpha(00000790)=0.000000000000000E+00 beta (00000791)=0.129915422585899E+02 gamma(00000791)=0.129915422585899E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.52823E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 791 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000791)=0.000000000000000E+00 beta (00000792)=0.134010495630518E+02 gamma(00000792)=0.134010495630518E+02 lr_calc_dens: Charge drift due to real space implementation = -0.21364E-10 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 792 z1= 1 -.222291560604411E-03 0.000000000000000E+00 z1= 2 0.763553631038780E-04 0.000000000000000E+00 z1= 3 -.152284198876923E-02 0.000000000000000E+00 alpha(00000792)=0.000000000000000E+00 beta (00000793)=0.130925046805045E+02 gamma(00000793)=0.130925046805045E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.57412E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 793 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000793)=0.000000000000000E+00 beta (00000794)=0.135318927966683E+02 gamma(00000794)=0.135318927966683E+02 lr_calc_dens: Charge drift due to real space implementation = 0.25287E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 794 z1= 1 0.225762110518673E-03 0.000000000000000E+00 z1= 2 -.777427924893521E-04 0.000000000000000E+00 z1= 3 0.151743605242989E-02 0.000000000000000E+00 alpha(00000794)=0.000000000000000E+00 beta (00000795)=0.131099441408780E+02 gamma(00000795)=0.131099441408780E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.20981E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 795 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000795)=0.000000000000000E+00 beta (00000796)=0.135061181819018E+02 gamma(00000796)=0.135061181819018E+02 lr_calc_dens: Charge drift due to real space implementation = -0.65168E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 796 z1= 1 -.230405314726867E-03 0.000000000000000E+00 z1= 2 0.786046551378611E-04 0.000000000000000E+00 z1= 3 -.168465564432425E-02 0.000000000000000E+00 alpha(00000796)=0.000000000000000E+00 beta (00000797)=0.129310491900868E+02 gamma(00000797)=0.129310491900868E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.28836E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 797 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000797)=0.000000000000000E+00 beta (00000798)=0.134244686852068E+02 gamma(00000798)=0.134244686852068E+02 lr_calc_dens: Charge drift due to real space implementation = -0.50057E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 798 z1= 1 0.233263968159762E-03 0.000000000000000E+00 z1= 2 -.803411153848336E-04 0.000000000000000E+00 z1= 3 0.183536009118419E-02 0.000000000000000E+00 alpha(00000798)=0.000000000000000E+00 beta (00000799)=0.130367317739248E+02 gamma(00000799)=0.130367317739248E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.40429E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 799 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000799)=0.000000000000000E+00 beta (00000800)=0.133881949189515E+02 gamma(00000800)=0.133881949189515E+02 lr_calc_dens: Charge drift due to real space implementation = 0.66839E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 800 z1= 1 -.238725983498322E-03 0.000000000000000E+00 z1= 2 0.815492099142139E-04 0.000000000000000E+00 z1= 3 -.222011246696789E-02 0.000000000000000E+00 alpha(00000800)=0.000000000000000E+00 beta (00000801)=0.131532907874102E+02 gamma(00000801)=0.131532907874102E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.11461E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 801 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000801)=0.000000000000000E+00 beta (00000802)=0.136037570873429E+02 gamma(00000802)=0.136037570873429E+02 lr_calc_dens: Charge drift due to real space implementation = -0.60007E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 802 z1= 1 0.241977237327277E-03 0.000000000000000E+00 z1= 2 -.822221190922651E-04 0.000000000000000E+00 z1= 3 0.283371826998051E-02 0.000000000000000E+00 alpha(00000802)=0.000000000000000E+00 beta (00000803)=0.129445788982082E+02 gamma(00000803)=0.129445788982082E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.13892E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 803 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000803)=0.000000000000000E+00 beta (00000804)=0.133291543864304E+02 gamma(00000804)=0.133291543864304E+02 lr_calc_dens: Charge drift due to real space implementation = -0.76858E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 804 z1= 1 -.247071735961736E-03 0.000000000000000E+00 z1= 2 0.826765539028873E-04 0.000000000000000E+00 z1= 3 -.343807358163041E-02 0.000000000000000E+00 alpha(00000804)=0.000000000000000E+00 beta (00000805)=0.130132968449940E+02 gamma(00000805)=0.130132968449940E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.84556E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 805 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000805)=0.000000000000000E+00 beta (00000806)=0.133678804612232E+02 gamma(00000806)=0.133678804612232E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11062E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 806 z1= 1 0.252358323078853E-03 0.000000000000000E+00 z1= 2 -.840399075504360E-04 0.000000000000000E+00 z1= 3 0.369255701002560E-02 0.000000000000000E+00 alpha(00000806)=0.000000000000000E+00 beta (00000807)=0.131022325974652E+02 gamma(00000807)=0.131022325974652E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.86026E-10 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 807 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000807)=0.000000000000000E+00 beta (00000808)=0.136289535351628E+02 gamma(00000808)=0.136289535351628E+02 lr_calc_dens: Charge drift due to real space implementation = -0.69647E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 808 z1= 1 -.253971157187118E-03 0.000000000000000E+00 z1= 2 0.832919751621557E-04 0.000000000000000E+00 z1= 3 -.348900367443678E-02 0.000000000000000E+00 alpha(00000808)=0.000000000000000E+00 beta (00000809)=0.130038488568433E+02 gamma(00000809)=0.130038488568433E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.51741E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 809 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000809)=0.000000000000000E+00 beta (00000810)=0.134708550206772E+02 gamma(00000810)=0.134708550206772E+02 lr_calc_dens: Charge drift due to real space implementation = -0.18123E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 810 z1= 1 0.256192855238775E-03 0.000000000000000E+00 z1= 2 -.840892543679282E-04 0.000000000000000E+00 z1= 3 0.311677303868617E-02 0.000000000000000E+00 alpha(00000810)=0.000000000000000E+00 beta (00000811)=0.131202862416453E+02 gamma(00000811)=0.131202862416453E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.16687E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 811 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000811)=0.000000000000000E+00 beta (00000812)=0.134514605294234E+02 gamma(00000812)=0.134514605294234E+02 lr_calc_dens: Charge drift due to real space implementation = 0.65749E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 812 z1= 1 -.261082234122677E-03 0.000000000000000E+00 z1= 2 0.851521694910320E-04 0.000000000000000E+00 z1= 3 -.289287010287199E-02 0.000000000000000E+00 alpha(00000812)=0.000000000000000E+00 beta (00000813)=0.130169143408845E+02 gamma(00000813)=0.130169143408845E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.64813E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 813 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000813)=0.000000000000000E+00 beta (00000814)=0.134100691362741E+02 gamma(00000814)=0.134100691362741E+02 lr_calc_dens: Charge drift due to real space implementation = -0.33100E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 814 z1= 1 0.264681704349974E-03 0.000000000000000E+00 z1= 2 -.867902908862986E-04 0.000000000000000E+00 z1= 3 0.296486651006809E-02 0.000000000000000E+00 alpha(00000814)=0.000000000000000E+00 beta (00000815)=0.129712991395319E+02 gamma(00000815)=0.129712991395319E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11934E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 815 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000815)=0.000000000000000E+00 beta (00000816)=0.135298497078945E+02 gamma(00000816)=0.135298497078945E+02 lr_calc_dens: Charge drift due to real space implementation = -0.55396E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 816 z1= 1 -.265057959578843E-03 0.000000000000000E+00 z1= 2 0.871989095863062E-04 0.000000000000000E+00 z1= 3 -.326693922068133E-02 0.000000000000000E+00 alpha(00000816)=0.000000000000000E+00 beta (00000817)=0.129963423125676E+02 gamma(00000817)=0.129963423125676E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.80128E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 817 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000817)=0.000000000000000E+00 beta (00000818)=0.133476245295816E+02 gamma(00000818)=0.133476245295816E+02 lr_calc_dens: Charge drift due to real space implementation = 0.90309E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 818 z1= 1 0.269055123806192E-03 0.000000000000000E+00 z1= 2 -.888820487118188E-04 0.000000000000000E+00 z1= 3 0.362218702400325E-02 0.000000000000000E+00 alpha(00000818)=0.000000000000000E+00 beta (00000819)=0.131556676666109E+02 gamma(00000819)=0.131556676666109E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.88870E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 819 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000819)=0.000000000000000E+00 beta (00000820)=0.133503992315590E+02 gamma(00000820)=0.133503992315590E+02 lr_calc_dens: Charge drift due to real space implementation = -0.43206E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 820 z1= 1 -.276436098982368E-03 0.000000000000000E+00 z1= 2 0.905403795607672E-04 0.000000000000000E+00 z1= 3 -.372138235486833E-02 0.000000000000000E+00 alpha(00000820)=0.000000000000000E+00 beta (00000821)=0.129895816324644E+02 gamma(00000821)=0.129895816324644E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10582E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 821 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000821)=0.000000000000000E+00 beta (00000822)=0.135777278450047E+02 gamma(00000822)=0.135777278450047E+02 lr_calc_dens: Charge drift due to real space implementation = -0.35267E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 822 z1= 1 0.275723243518257E-03 0.000000000000000E+00 z1= 2 -.898950401549357E-04 0.000000000000000E+00 z1= 3 0.348518354390212E-02 0.000000000000000E+00 alpha(00000822)=0.000000000000000E+00 beta (00000823)=0.129422440817314E+02 gamma(00000823)=0.129422440817314E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.58874E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 823 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000823)=0.000000000000000E+00 beta (00000824)=0.135620144851850E+02 gamma(00000824)=0.135620144851850E+02 lr_calc_dens: Charge drift due to real space implementation = 0.43686E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 824 z1= 1 -.274563762894571E-03 0.000000000000000E+00 z1= 2 0.894186101905313E-04 0.000000000000000E+00 z1= 3 -.326921364469088E-02 0.000000000000000E+00 alpha(00000824)=0.000000000000000E+00 beta (00000825)=0.130200168245505E+02 gamma(00000825)=0.130200168245505E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14781E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 825 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000825)=0.000000000000000E+00 beta (00000826)=0.134254792168029E+02 gamma(00000826)=0.134254792168029E+02 lr_calc_dens: Charge drift due to real space implementation = 0.53190E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 826 z1= 1 0.277063079176129E-03 0.000000000000000E+00 z1= 2 -.909623730374028E-04 0.000000000000000E+00 z1= 3 0.333073824569127E-02 0.000000000000000E+00 alpha(00000826)=0.000000000000000E+00 beta (00000827)=0.129822029392317E+02 gamma(00000827)=0.129822029392317E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.13040E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 827 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000827)=0.000000000000000E+00 beta (00000828)=0.134676004720997E+02 gamma(00000828)=0.134676004720997E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12818E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 828 z1= 1 -.277784551932752E-03 0.000000000000000E+00 z1= 2 0.923110999812092E-04 0.000000000000000E+00 z1= 3 -.347111759930572E-02 0.000000000000000E+00 alpha(00000828)=0.000000000000000E+00 beta (00000829)=0.129990957034729E+02 gamma(00000829)=0.129990957034729E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.38265E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 829 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000829)=0.000000000000000E+00 beta (00000830)=0.135151099989302E+02 gamma(00000830)=0.135151099989302E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10042E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 830 z1= 1 0.277730777356024E-03 0.000000000000000E+00 z1= 2 -.939425439880796E-04 0.000000000000000E+00 z1= 3 0.340479880899240E-02 0.000000000000000E+00 alpha(00000830)=0.000000000000000E+00 beta (00000831)=0.131220004655290E+02 gamma(00000831)=0.131220004655290E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12201E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 831 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000831)=0.000000000000000E+00 beta (00000832)=0.133456094817392E+02 gamma(00000832)=0.133456094817392E+02 lr_calc_dens: Charge drift due to real space implementation = -0.37116E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 832 z1= 1 -.284159763529198E-03 0.000000000000000E+00 z1= 2 0.967377925695591E-04 0.000000000000000E+00 z1= 3 -.314302403647951E-02 0.000000000000000E+00 alpha(00000832)=0.000000000000000E+00 beta (00000833)=0.130216305478106E+02 gamma(00000833)=0.130216305478106E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.64534E-10 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 833 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000833)=0.000000000000000E+00 beta (00000834)=0.135127027717610E+02 gamma(00000834)=0.135127027717610E+02 lr_calc_dens: Charge drift due to real space implementation = 0.40460E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 834 z1= 1 0.284538276107566E-03 0.000000000000000E+00 z1= 2 -.973306724285871E-04 0.000000000000000E+00 z1= 3 0.276253348815524E-02 0.000000000000000E+00 alpha(00000834)=0.000000000000000E+00 beta (00000835)=0.129888075024228E+02 gamma(00000835)=0.129888075024228E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.34662E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 835 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000835)=0.000000000000000E+00 beta (00000836)=0.135646934130885E+02 gamma(00000836)=0.135646934130885E+02 lr_calc_dens: Charge drift due to real space implementation = -0.80195E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 836 z1= 1 -.283715229537230E-03 0.000000000000000E+00 z1= 2 0.967338888275876E-04 0.000000000000000E+00 z1= 3 -.262311217657955E-02 0.000000000000000E+00 alpha(00000836)=0.000000000000000E+00 beta (00000837)=0.130420193015715E+02 gamma(00000837)=0.130420193015715E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.66527E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 837 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000837)=0.000000000000000E+00 beta (00000838)=0.135214905262437E+02 gamma(00000838)=0.135214905262437E+02 lr_calc_dens: Charge drift due to real space implementation = 0.46233E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 838 z1= 1 0.284642949887701E-03 0.000000000000000E+00 z1= 2 -.963813428407722E-04 0.000000000000000E+00 z1= 3 0.281063556606985E-02 0.000000000000000E+00 alpha(00000838)=0.000000000000000E+00 beta (00000839)=0.129846781469793E+02 gamma(00000839)=0.129846781469793E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.68988E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 839 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000839)=0.000000000000000E+00 beta (00000840)=0.133721879610365E+02 gamma(00000840)=0.133721879610365E+02 lr_calc_dens: Charge drift due to real space implementation = -0.89064E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 840 z1= 1 -.287474378966603E-03 0.000000000000000E+00 z1= 2 0.961861923896820E-04 0.000000000000000E+00 z1= 3 -.311763920091583E-02 0.000000000000000E+00 alpha(00000840)=0.000000000000000E+00 beta (00000841)=0.131384467080448E+02 gamma(00000841)=0.131384467080448E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.36097E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 841 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000841)=0.000000000000000E+00 beta (00000842)=0.134506166484425E+02 gamma(00000842)=0.134506166484425E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10787E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 842 z1= 1 0.291534733382542E-03 0.000000000000000E+00 z1= 2 -.971317924082778E-04 0.000000000000000E+00 z1= 3 0.322237522054943E-02 0.000000000000000E+00 alpha(00000842)=0.000000000000000E+00 beta (00000843)=0.129403849842217E+02 gamma(00000843)=0.129403849842217E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14291E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 843 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000843)=0.000000000000000E+00 beta (00000844)=0.135070537401155E+02 gamma(00000844)=0.135070537401155E+02 lr_calc_dens: Charge drift due to real space implementation = -0.78047E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 844 z1= 1 -.291571618638232E-03 0.000000000000000E+00 z1= 2 0.959796614612843E-04 0.000000000000000E+00 z1= 3 -.280016269237117E-02 0.000000000000000E+00 alpha(00000844)=0.000000000000000E+00 beta (00000845)=0.130233745774535E+02 gamma(00000845)=0.130233745774535E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.34346E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 845 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000845)=0.000000000000000E+00 beta (00000846)=0.134932340015969E+02 gamma(00000846)=0.134932340015969E+02 lr_calc_dens: Charge drift due to real space implementation = 0.40178E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 846 z1= 1 0.293757884143122E-03 0.000000000000000E+00 z1= 2 -.955267129539982E-04 0.000000000000000E+00 z1= 3 0.196138346500159E-02 0.000000000000000E+00 alpha(00000846)=0.000000000000000E+00 beta (00000847)=0.130023317987893E+02 gamma(00000847)=0.130023317987893E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.21883E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 847 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000847)=0.000000000000000E+00 beta (00000848)=0.135648372266650E+02 gamma(00000848)=0.135648372266650E+02 lr_calc_dens: Charge drift due to real space implementation = -0.32158E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 848 z1= 1 -.294469168774142E-03 0.000000000000000E+00 z1= 2 0.939227867736998E-04 0.000000000000000E+00 z1= 3 -.846192134853291E-03 0.000000000000000E+00 alpha(00000848)=0.000000000000000E+00 beta (00000849)=0.129921255318164E+02 gamma(00000849)=0.129921255318164E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.21246E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 849 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000849)=0.000000000000000E+00 beta (00000850)=0.136360151714648E+02 gamma(00000850)=0.136360151714648E+02 lr_calc_dens: Charge drift due to real space implementation = 0.31368E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 850 z1= 1 0.292953791266267E-03 0.000000000000000E+00 z1= 2 -.922751393217762E-04 0.000000000000000E+00 z1= 3 -.247934628952642E-03 0.000000000000000E+00 alpha(00000850)=0.000000000000000E+00 beta (00000851)=0.130838805901598E+02 gamma(00000851)=0.130838805901598E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.36460E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 851 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000851)=0.000000000000000E+00 beta (00000852)=0.135527205528318E+02 gamma(00000852)=0.135527205528318E+02 lr_calc_dens: Charge drift due to real space implementation = -0.16891E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 852 z1= 1 -.295996724924326E-03 0.000000000000000E+00 z1= 2 0.919082803395353E-04 0.000000000000000E+00 z1= 3 0.108454085296293E-02 0.000000000000000E+00 alpha(00000852)=0.000000000000000E+00 beta (00000853)=0.130471850808569E+02 gamma(00000853)=0.130471850808569E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.33977E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 853 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000853)=0.000000000000000E+00 beta (00000854)=0.134137793280356E+02 gamma(00000854)=0.134137793280356E+02 lr_calc_dens: Charge drift due to real space implementation = 0.20650E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 854 z1= 1 0.300764471107021E-03 0.000000000000000E+00 z1= 2 -.933842763863332E-04 0.000000000000000E+00 z1= 3 -.164307060190842E-02 0.000000000000000E+00 alpha(00000854)=0.000000000000000E+00 beta (00000855)=0.130327381233428E+02 gamma(00000855)=0.130327381233428E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.32881E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 855 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000855)=0.000000000000000E+00 beta (00000856)=0.134628652703259E+02 gamma(00000856)=0.134628652703259E+02 lr_calc_dens: Charge drift due to real space implementation = -0.40515E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 856 z1= 1 -.303456787926453E-03 0.000000000000000E+00 z1= 2 0.945688536156026E-04 0.000000000000000E+00 z1= 3 0.197682127769778E-02 0.000000000000000E+00 alpha(00000856)=0.000000000000000E+00 beta (00000857)=0.129868533593082E+02 gamma(00000857)=0.129868533593082E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.65574E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 857 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000857)=0.000000000000000E+00 beta (00000858)=0.134756846762381E+02 gamma(00000858)=0.134756846762381E+02 lr_calc_dens: Charge drift due to real space implementation = 0.24537E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 858 z1= 1 0.303671045820330E-03 0.000000000000000E+00 z1= 2 -.968738789806756E-04 0.000000000000000E+00 z1= 3 -.227753446136853E-02 0.000000000000000E+00 alpha(00000858)=0.000000000000000E+00 beta (00000859)=0.131667232140644E+02 gamma(00000859)=0.131667232140644E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.87583E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 859 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000859)=0.000000000000000E+00 beta (00000860)=0.133959321393578E+02 gamma(00000860)=0.133959321393578E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11804E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 860 z1= 1 -.309917237497382E-03 0.000000000000000E+00 z1= 2 0.101316804860492E-03 0.000000000000000E+00 z1= 3 0.273892024552529E-02 0.000000000000000E+00 alpha(00000860)=0.000000000000000E+00 beta (00000861)=0.130506302784186E+02 gamma(00000861)=0.130506302784186E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.81210E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 861 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000861)=0.000000000000000E+00 beta (00000862)=0.134814188106709E+02 gamma(00000862)=0.134814188106709E+02 lr_calc_dens: Charge drift due to real space implementation = -0.46468E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 862 z1= 1 0.310905422012447E-03 0.000000000000000E+00 z1= 2 -.104181272845603E-03 0.000000000000000E+00 z1= 3 -.325860344215977E-02 0.000000000000000E+00 alpha(00000862)=0.000000000000000E+00 beta (00000863)=0.130343444769095E+02 gamma(00000863)=0.130343444769095E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.38841E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 863 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000863)=0.000000000000000E+00 beta (00000864)=0.135242851650321E+02 gamma(00000864)=0.135242851650321E+02 lr_calc_dens: Charge drift due to real space implementation = 0.34509E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 864 z1= 1 -.311249855264371E-03 0.000000000000000E+00 z1= 2 0.105550170512675E-03 0.000000000000000E+00 z1= 3 0.369821223378740E-02 0.000000000000000E+00 alpha(00000864)=0.000000000000000E+00 beta (00000865)=0.129450384125067E+02 gamma(00000865)=0.129450384125067E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.25584E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 865 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000865)=0.000000000000000E+00 beta (00000866)=0.135988319952166E+02 gamma(00000866)=0.135988319952166E+02 lr_calc_dens: Charge drift due to real space implementation = -0.29291E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 866 z1= 1 0.307797577625395E-03 0.000000000000000E+00 z1= 2 -.104767343633422E-03 0.000000000000000E+00 z1= 3 -.393850070190280E-02 0.000000000000000E+00 alpha(00000866)=0.000000000000000E+00 beta (00000867)=0.130054851194841E+02 gamma(00000867)=0.130054851194841E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.19135E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 867 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000867)=0.000000000000000E+00 beta (00000868)=0.135734716524699E+02 gamma(00000868)=0.135734716524699E+02 lr_calc_dens: Charge drift due to real space implementation = 0.32833E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 868 z1= 1 -.307159133158547E-03 0.000000000000000E+00 z1= 2 0.104056190613924E-03 0.000000000000000E+00 z1= 3 0.407193257637890E-02 0.000000000000000E+00 alpha(00000868)=0.000000000000000E+00 beta (00000869)=0.129505901987701E+02 gamma(00000869)=0.129505901987701E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.15760E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 869 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000869)=0.000000000000000E+00 beta (00000870)=0.134280764810483E+02 gamma(00000870)=0.134280764810483E+02 lr_calc_dens: Charge drift due to real space implementation = -0.76990E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 870 z1= 1 0.308277989698896E-03 0.000000000000000E+00 z1= 2 -.103836428525501E-03 0.000000000000000E+00 z1= 3 -.406095660731927E-02 0.000000000000000E+00 alpha(00000870)=0.000000000000000E+00 beta (00000871)=0.130267462810422E+02 gamma(00000871)=0.130267462810422E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.20935E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 871 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000871)=0.000000000000000E+00 beta (00000872)=0.134863008950234E+02 gamma(00000872)=0.134863008950234E+02 lr_calc_dens: Charge drift due to real space implementation = -0.28815E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 872 z1= 1 -.309858472448157E-03 0.000000000000000E+00 z1= 2 0.104710639648091E-03 0.000000000000000E+00 z1= 3 0.401662721048333E-02 0.000000000000000E+00 alpha(00000872)=0.000000000000000E+00 beta (00000873)=0.130054719246533E+02 gamma(00000873)=0.130054719246533E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.44661E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 873 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000873)=0.000000000000000E+00 beta (00000874)=0.134934679789243E+02 gamma(00000874)=0.134934679789243E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12098E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 874 z1= 1 0.309811368403541E-03 0.000000000000000E+00 z1= 2 -.105031023801235E-03 0.000000000000000E+00 z1= 3 -.413854126893647E-02 0.000000000000000E+00 alpha(00000874)=0.000000000000000E+00 beta (00000875)=0.129693748458343E+02 gamma(00000875)=0.129693748458343E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.83537E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 875 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000875)=0.000000000000000E+00 beta (00000876)=0.135895049872495E+02 gamma(00000876)=0.135895049872495E+02 lr_calc_dens: Charge drift due to real space implementation = 0.52693E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 876 z1= 1 -.306812986209789E-03 0.000000000000000E+00 z1= 2 0.105329003008985E-03 0.000000000000000E+00 z1= 3 0.434032635787917E-02 0.000000000000000E+00 alpha(00000876)=0.000000000000000E+00 beta (00000877)=0.130312062185489E+02 gamma(00000877)=0.130312062185489E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.63565E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 877 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000877)=0.000000000000000E+00 beta (00000878)=0.134840946631912E+02 gamma(00000878)=0.134840946631912E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10518E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 878 z1= 1 0.307181135835125E-03 0.000000000000000E+00 z1= 2 -.106057904794037E-03 0.000000000000000E+00 z1= 3 -.456078117193899E-02 0.000000000000000E+00 alpha(00000878)=0.000000000000000E+00 beta (00000879)=0.131946721251000E+02 gamma(00000879)=0.131946721251000E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11692E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 879 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000879)=0.000000000000000E+00 beta (00000880)=0.135622777235450E+02 gamma(00000880)=0.135622777235450E+02 lr_calc_dens: Charge drift due to real space implementation = 0.76306E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 880 z1= 1 -.308878679983391E-03 0.000000000000000E+00 z1= 2 0.108627450821661E-03 0.000000000000000E+00 z1= 3 0.454477296763427E-02 0.000000000000000E+00 alpha(00000880)=0.000000000000000E+00 beta (00000881)=0.129670243277541E+02 gamma(00000881)=0.129670243277541E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.53280E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 881 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000881)=0.000000000000000E+00 beta (00000882)=0.134260944948810E+02 gamma(00000882)=0.134260944948810E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11427E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 882 z1= 1 0.308186867153176E-03 0.000000000000000E+00 z1= 2 -.109708756464455E-03 0.000000000000000E+00 z1= 3 -.415586276438439E-02 0.000000000000000E+00 alpha(00000882)=0.000000000000000E+00 beta (00000883)=0.129167730505039E+02 gamma(00000883)=0.129167730505039E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.38225E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 883 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000883)=0.000000000000000E+00 beta (00000884)=0.135956958426585E+02 gamma(00000884)=0.135956958426585E+02 lr_calc_dens: Charge drift due to real space implementation = -0.26955E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 884 z1= 1 -.302743420885860E-03 0.000000000000000E+00 z1= 2 0.109886908748684E-03 0.000000000000000E+00 z1= 3 0.353893810842476E-02 0.000000000000000E+00 alpha(00000884)=0.000000000000000E+00 beta (00000885)=0.128700718620645E+02 gamma(00000885)=0.128700718620645E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.62062E-10 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 885 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000885)=0.000000000000000E+00 beta (00000886)=0.135043064290847E+02 gamma(00000886)=0.135043064290847E+02 lr_calc_dens: Charge drift due to real space implementation = 0.24556E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 886 z1= 1 0.298446088300244E-03 0.000000000000000E+00 z1= 2 -.109475230003245E-03 0.000000000000000E+00 z1= 3 -.290703066716627E-02 0.000000000000000E+00 alpha(00000886)=0.000000000000000E+00 beta (00000887)=0.128943265287644E+02 gamma(00000887)=0.128943265287644E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.19161E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 887 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000887)=0.000000000000000E+00 beta (00000888)=0.135623346022516E+02 gamma(00000888)=0.135623346022516E+02 lr_calc_dens: Charge drift due to real space implementation = -0.98954E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 888 z1= 1 -.293543562196262E-03 0.000000000000000E+00 z1= 2 0.110069665793672E-03 0.000000000000000E+00 z1= 3 0.249526063704399E-02 0.000000000000000E+00 alpha(00000888)=0.000000000000000E+00 beta (00000889)=0.130199769550375E+02 gamma(00000889)=0.130199769550375E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.26623E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 889 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000889)=0.000000000000000E+00 beta (00000890)=0.135059488237266E+02 gamma(00000890)=0.135059488237266E+02 lr_calc_dens: Charge drift due to real space implementation = -0.84112E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 890 z1= 1 0.292434399094645E-03 0.000000000000000E+00 z1= 2 -.110645872872859E-03 0.000000000000000E+00 z1= 3 -.246039204404177E-02 0.000000000000000E+00 alpha(00000890)=0.000000000000000E+00 beta (00000891)=0.129603446872811E+02 gamma(00000891)=0.129603446872811E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.29694E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 891 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000891)=0.000000000000000E+00 beta (00000892)=0.135471839339552E+02 gamma(00000892)=0.135471839339552E+02 lr_calc_dens: Charge drift due to real space implementation = 0.38589E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 892 z1= 1 -.288732617664881E-03 0.000000000000000E+00 z1= 2 0.111856509826612E-03 0.000000000000000E+00 z1= 3 0.260983653898438E-02 0.000000000000000E+00 alpha(00000892)=0.000000000000000E+00 beta (00000893)=0.130173374813231E+02 gamma(00000893)=0.130173374813231E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.41949E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 893 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000893)=0.000000000000000E+00 beta (00000894)=0.135607360489613E+02 gamma(00000894)=0.135607360489613E+02 lr_calc_dens: Charge drift due to real space implementation = -0.46896E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 894 z1= 1 0.286352603015063E-03 0.000000000000000E+00 z1= 2 -.110632570212435E-03 0.000000000000000E+00 z1= 3 -.270519056315068E-02 0.000000000000000E+00 alpha(00000894)=0.000000000000000E+00 beta (00000895)=0.129704675219178E+02 gamma(00000895)=0.129704675219178E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.33108E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 895 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000895)=0.000000000000000E+00 beta (00000896)=0.135880088778809E+02 gamma(00000896)=0.135880088778809E+02 lr_calc_dens: Charge drift due to real space implementation = 0.16756E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 896 z1= 1 -.283140234076709E-03 0.000000000000000E+00 z1= 2 0.109803547315522E-03 0.000000000000000E+00 z1= 3 0.251466790677510E-02 0.000000000000000E+00 alpha(00000896)=0.000000000000000E+00 beta (00000897)=0.129254891924118E+02 gamma(00000897)=0.129254891924118E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.39209E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 897 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000897)=0.000000000000000E+00 beta (00000898)=0.135222673514672E+02 gamma(00000898)=0.135222673514672E+02 lr_calc_dens: Charge drift due to real space implementation = 0.15365E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 898 z1= 1 0.281270735911415E-03 0.000000000000000E+00 z1= 2 -.107404254636361E-03 0.000000000000000E+00 z1= 3 -.209875791634657E-02 0.000000000000000E+00 alpha(00000898)=0.000000000000000E+00 beta (00000899)=0.130388541452323E+02 gamma(00000899)=0.130388541452323E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.18399E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 899 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000899)=0.000000000000000E+00 beta (00000900)=0.135470027978997E+02 gamma(00000900)=0.135470027978997E+02 lr_calc_dens: Charge drift due to real space implementation = -0.24955E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 900 z1= 1 -.281334104246244E-03 0.000000000000000E+00 z1= 2 0.108234893152816E-03 0.000000000000000E+00 z1= 3 0.164915021920816E-02 0.000000000000000E+00 alpha(00000900)=0.000000000000000E+00 beta (00000901)=0.131346872489155E+02 gamma(00000901)=0.131346872489155E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10821E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 901 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000901)=0.000000000000000E+00 beta (00000902)=0.135027657226465E+02 gamma(00000902)=0.135027657226465E+02 lr_calc_dens: Charge drift due to real space implementation = 0.22088E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 902 z1= 1 0.284795878290663E-03 0.000000000000000E+00 z1= 2 -.108457021418627E-03 0.000000000000000E+00 z1= 3 -.140642333597567E-02 0.000000000000000E+00 alpha(00000902)=0.000000000000000E+00 beta (00000903)=0.130127902018588E+02 gamma(00000903)=0.130127902018588E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12213E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 903 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000903)=0.000000000000000E+00 beta (00000904)=0.134589684149490E+02 gamma(00000904)=0.134589684149490E+02 lr_calc_dens: Charge drift due to real space implementation = -0.16133E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 904 z1= 1 -.286097976050891E-03 0.000000000000000E+00 z1= 2 0.110318049678373E-03 0.000000000000000E+00 z1= 3 0.142538610278439E-02 0.000000000000000E+00 alpha(00000904)=0.000000000000000E+00 beta (00000905)=0.130965007716526E+02 gamma(00000905)=0.130965007716526E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.18861E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 905 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000905)=0.000000000000000E+00 beta (00000906)=0.135339243521125E+02 gamma(00000906)=0.135339243521125E+02 lr_calc_dens: Charge drift due to real space implementation = 0.22838E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 906 z1= 1 0.287411293300890E-03 0.000000000000000E+00 z1= 2 -.110807293229658E-03 0.000000000000000E+00 z1= 3 -.157405748379635E-02 0.000000000000000E+00 alpha(00000906)=0.000000000000000E+00 beta (00000907)=0.129868025809162E+02 gamma(00000907)=0.129868025809162E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10529E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 907 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000907)=0.000000000000000E+00 beta (00000908)=0.136124100465758E+02 gamma(00000908)=0.136124100465758E+02 lr_calc_dens: Charge drift due to real space implementation = 0.29835E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 908 z1= 1 -.284557625465306E-03 0.000000000000000E+00 z1= 2 0.111713455472616E-03 0.000000000000000E+00 z1= 3 0.157573456189913E-02 0.000000000000000E+00 alpha(00000908)=0.000000000000000E+00 beta (00000909)=0.128784423135992E+02 gamma(00000909)=0.128784423135992E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.18982E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 909 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000909)=0.000000000000000E+00 beta (00000910)=0.137718738938291E+02 gamma(00000910)=0.137718738938291E+02 lr_calc_dens: Charge drift due to real space implementation = -0.89934E-11 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 910 z1= 1 0.277129547863484E-03 0.000000000000000E+00 z1= 2 -.109574980301482E-03 0.000000000000000E+00 z1= 3 -.125998056654454E-02 0.000000000000000E+00 alpha(00000910)=0.000000000000000E+00 beta (00000911)=0.129002082251615E+02 gamma(00000911)=0.129002082251615E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.47553E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 911 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000911)=0.000000000000000E+00 beta (00000912)=0.136641858468708E+02 gamma(00000912)=0.136641858468708E+02 lr_calc_dens: Charge drift due to real space implementation = -0.17594E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 912 z1= 1 -.272571223147713E-03 0.000000000000000E+00 z1= 2 0.110367418827036E-03 0.000000000000000E+00 z1= 3 0.782418345560743E-03 0.000000000000000E+00 alpha(00000912)=0.000000000000000E+00 beta (00000913)=0.129173071346469E+02 gamma(00000913)=0.129173071346469E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.15454E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 913 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000913)=0.000000000000000E+00 beta (00000914)=0.135293169188464E+02 gamma(00000914)=0.135293169188464E+02 lr_calc_dens: Charge drift due to real space implementation = 0.67471E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 914 z1= 1 0.272088312580713E-03 0.000000000000000E+00 z1= 2 -.111074291886833E-03 0.000000000000000E+00 z1= 3 -.256264585326614E-03 0.000000000000000E+00 alpha(00000914)=0.000000000000000E+00 beta (00000915)=0.130540074067861E+02 gamma(00000915)=0.130540074067861E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.51664E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 915 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000915)=0.000000000000000E+00 beta (00000916)=0.134569867516555E+02 gamma(00000916)=0.134569867516555E+02 lr_calc_dens: Charge drift due to real space implementation = -0.25702E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 916 z1= 1 -.275523194497066E-03 0.000000000000000E+00 z1= 2 0.113639966882306E-03 0.000000000000000E+00 z1= 3 0.530449837224389E-05 0.000000000000000E+00 alpha(00000916)=0.000000000000000E+00 beta (00000917)=0.130264374490532E+02 gamma(00000917)=0.130264374490532E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.21798E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 917 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000917)=0.000000000000000E+00 beta (00000918)=0.134927723555794E+02 gamma(00000918)=0.134927723555794E+02 lr_calc_dens: Charge drift due to real space implementation = 0.27882E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 918 z1= 1 0.277765010079332E-03 0.000000000000000E+00 z1= 2 -.114789431308338E-03 0.000000000000000E+00 z1= 3 -.301059496749185E-03 0.000000000000000E+00 alpha(00000918)=0.000000000000000E+00 beta (00000919)=0.128985459773590E+02 gamma(00000919)=0.128985459773590E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.50011E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 919 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000919)=0.000000000000000E+00 beta (00000920)=0.134622054364611E+02 gamma(00000920)=0.134622054364611E+02 lr_calc_dens: Charge drift due to real space implementation = 0.57220E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 920 z1= 1 -.278206644098261E-03 0.000000000000000E+00 z1= 2 0.115888750717038E-03 0.000000000000000E+00 z1= 3 0.866192368045604E-03 0.000000000000000E+00 alpha(00000920)=0.000000000000000E+00 beta (00000921)=0.129203761039680E+02 gamma(00000921)=0.129203761039680E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.39912E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 921 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000921)=0.000000000000000E+00 beta (00000922)=0.135026699095935E+02 gamma(00000922)=0.135026699095935E+02 lr_calc_dens: Charge drift due to real space implementation = -0.21792E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 922 z1= 1 0.279747883975515E-03 0.000000000000000E+00 z1= 2 -.116930108979983E-03 0.000000000000000E+00 z1= 3 -.126597109266971E-02 0.000000000000000E+00 alpha(00000922)=0.000000000000000E+00 beta (00000923)=0.129136074805002E+02 gamma(00000923)=0.129136074805002E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12195E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 923 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000923)=0.000000000000000E+00 beta (00000924)=0.135065897951916E+02 gamma(00000924)=0.135065897951916E+02 lr_calc_dens: Charge drift due to real space implementation = -0.80475E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 924 z1= 1 -.281756973876784E-03 0.000000000000000E+00 z1= 2 0.118383008570900E-03 0.000000000000000E+00 z1= 3 0.136627518893389E-02 0.000000000000000E+00 alpha(00000924)=0.000000000000000E+00 beta (00000925)=0.129962705512988E+02 gamma(00000925)=0.129962705512988E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.33393E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 925 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000925)=0.000000000000000E+00 beta (00000926)=0.134855044629430E+02 gamma(00000926)=0.134855044629430E+02 lr_calc_dens: Charge drift due to real space implementation = 0.22794E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 926 z1= 1 0.287085030800136E-03 0.000000000000000E+00 z1= 2 -.120650265415472E-03 0.000000000000000E+00 z1= 3 -.132825139612299E-02 0.000000000000000E+00 alpha(00000926)=0.000000000000000E+00 beta (00000927)=0.129028400643731E+02 gamma(00000927)=0.129028400643731E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.44251E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 927 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000927)=0.000000000000000E+00 beta (00000928)=0.135363429018612E+02 gamma(00000928)=0.135363429018612E+02 lr_calc_dens: Charge drift due to real space implementation = 0.17475E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 928 z1= 1 -.288575549907719E-03 0.000000000000000E+00 z1= 2 0.122412569854465E-03 0.000000000000000E+00 z1= 3 0.127612642952898E-02 0.000000000000000E+00 alpha(00000928)=0.000000000000000E+00 beta (00000929)=0.129894144667987E+02 gamma(00000929)=0.129894144667987E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.25981E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 929 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000929)=0.000000000000000E+00 beta (00000930)=0.136565924517547E+02 gamma(00000930)=0.136565924517547E+02 lr_calc_dens: Charge drift due to real space implementation = -0.73259E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 930 z1= 1 0.289811648177585E-03 0.000000000000000E+00 z1= 2 -.122901981583527E-03 0.000000000000000E+00 z1= 3 -.131108542917327E-02 0.000000000000000E+00 alpha(00000930)=0.000000000000000E+00 beta (00000931)=0.129817199700579E+02 gamma(00000931)=0.129817199700579E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.27794E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 931 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000931)=0.000000000000000E+00 beta (00000932)=0.134717971362422E+02 gamma(00000932)=0.134717971362422E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11518E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 932 z1= 1 -.294506937795342E-03 0.000000000000000E+00 z1= 2 0.125178778042389E-03 0.000000000000000E+00 z1= 3 0.145813718250883E-02 0.000000000000000E+00 alpha(00000932)=0.000000000000000E+00 beta (00000933)=0.130063002042723E+02 gamma(00000933)=0.130063002042723E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.25856E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 933 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000933)=0.000000000000000E+00 beta (00000934)=0.134718331865670E+02 gamma(00000934)=0.134718331865670E+02 lr_calc_dens: Charge drift due to real space implementation = -0.27605E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 934 z1= 1 0.299704627511112E-03 0.000000000000000E+00 z1= 2 -.127639532791564E-03 0.000000000000000E+00 z1= 3 -.154980993117413E-02 0.000000000000000E+00 alpha(00000934)=0.000000000000000E+00 beta (00000935)=0.130093002995564E+02 gamma(00000935)=0.130093002995564E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.28378E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 935 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000935)=0.000000000000000E+00 beta (00000936)=0.136482483140572E+02 gamma(00000936)=0.136482483140572E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10209E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 936 z1= 1 -.299657782394220E-03 0.000000000000000E+00 z1= 2 0.128053418437458E-03 0.000000000000000E+00 z1= 3 0.153880156390881E-02 0.000000000000000E+00 alpha(00000936)=0.000000000000000E+00 beta (00000937)=0.130047055258369E+02 gamma(00000937)=0.130047055258369E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12544E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 937 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000937)=0.000000000000000E+00 beta (00000938)=0.135530263762595E+02 gamma(00000938)=0.135530263762595E+02 lr_calc_dens: Charge drift due to real space implementation = 0.13953E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 938 z1= 1 0.301902071254784E-03 0.000000000000000E+00 z1= 2 -.129488939827735E-03 0.000000000000000E+00 z1= 3 -.154740803547849E-02 0.000000000000000E+00 alpha(00000938)=0.000000000000000E+00 beta (00000939)=0.128712910604838E+02 gamma(00000939)=0.128712910604838E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.16329E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 939 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000939)=0.000000000000000E+00 beta (00000940)=0.135162058917703E+02 gamma(00000940)=0.135162058917703E+02 lr_calc_dens: Charge drift due to real space implementation = -0.38407E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 940 z1= 1 -.300893304781535E-03 0.000000000000000E+00 z1= 2 0.129780636697191E-03 0.000000000000000E+00 z1= 3 0.158297547132382E-02 0.000000000000000E+00 alpha(00000940)=0.000000000000000E+00 beta (00000941)=0.129744559521340E+02 gamma(00000941)=0.129744559521340E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.42992E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 941 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000941)=0.000000000000000E+00 beta (00000942)=0.134616981613574E+02 gamma(00000942)=0.134616981613574E+02 lr_calc_dens: Charge drift due to real space implementation = 0.23941E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 942 z1= 1 0.303644245640047E-03 0.000000000000000E+00 z1= 2 -.132931930356079E-03 0.000000000000000E+00 z1= 3 -.179554359859585E-02 0.000000000000000E+00 alpha(00000942)=0.000000000000000E+00 beta (00000943)=0.130048682112789E+02 gamma(00000943)=0.130048682112789E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.83808E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 943 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000943)=0.000000000000000E+00 beta (00000944)=0.134731116107014E+02 gamma(00000944)=0.134731116107014E+02 lr_calc_dens: Charge drift due to real space implementation = 0.21661E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 944 z1= 1 -.305885398850618E-03 0.000000000000000E+00 z1= 2 0.135008222167772E-03 0.000000000000000E+00 z1= 3 0.211614964045075E-02 0.000000000000000E+00 alpha(00000944)=0.000000000000000E+00 beta (00000945)=0.130389360906179E+02 gamma(00000945)=0.130389360906179E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.96850E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 945 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000945)=0.000000000000000E+00 beta (00000946)=0.136023813708635E+02 gamma(00000946)=0.136023813708635E+02 lr_calc_dens: Charge drift due to real space implementation = -0.82601E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 946 z1= 1 0.307013150288070E-03 0.000000000000000E+00 z1= 2 -.137185619117829E-03 0.000000000000000E+00 z1= 3 -.235056595420760E-02 0.000000000000000E+00 alpha(00000946)=0.000000000000000E+00 beta (00000947)=0.130529642241158E+02 gamma(00000947)=0.130529642241158E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.49519E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 947 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000947)=0.000000000000000E+00 beta (00000948)=0.134480110782881E+02 gamma(00000948)=0.134480110782881E+02 lr_calc_dens: Charge drift due to real space implementation = 0.95773E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 948 z1= 1 -.311319540783039E-03 0.000000000000000E+00 z1= 2 0.139924136053971E-03 0.000000000000000E+00 z1= 3 0.228113849760537E-02 0.000000000000000E+00 alpha(00000948)=0.000000000000000E+00 beta (00000949)=0.130333307952989E+02 gamma(00000949)=0.130333307952989E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.25317E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 949 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000949)=0.000000000000000E+00 beta (00000950)=0.134766467515930E+02 gamma(00000950)=0.134766467515930E+02 lr_calc_dens: Charge drift due to real space implementation = -0.40205E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 950 z1= 1 0.314934335889069E-03 0.000000000000000E+00 z1= 2 -.143335912376550E-03 0.000000000000000E+00 z1= 3 -.184537389849497E-02 0.000000000000000E+00 alpha(00000950)=0.000000000000000E+00 beta (00000951)=0.131032712595976E+02 gamma(00000951)=0.131032712595976E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.65399E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 951 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000951)=0.000000000000000E+00 beta (00000952)=0.135524564062324E+02 gamma(00000952)=0.135524564062324E+02 lr_calc_dens: Charge drift due to real space implementation = -0.50978E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 952 z1= 1 -.317141849495707E-03 0.000000000000000E+00 z1= 2 0.145620328598062E-03 0.000000000000000E+00 z1= 3 0.133811480752227E-02 0.000000000000000E+00 alpha(00000952)=0.000000000000000E+00 beta (00000953)=0.129981585114447E+02 gamma(00000953)=0.129981585114447E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.17791E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 953 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000953)=0.000000000000000E+00 beta (00000954)=0.135720749141716E+02 gamma(00000954)=0.135720749141716E+02 lr_calc_dens: Charge drift due to real space implementation = 0.80247E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 954 z1= 1 0.317321189381842E-03 0.000000000000000E+00 z1= 2 -.147132086502262E-03 0.000000000000000E+00 z1= 3 -.109385723619987E-02 0.000000000000000E+00 alpha(00000954)=0.000000000000000E+00 beta (00000955)=0.130567835147354E+02 gamma(00000955)=0.130567835147354E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.63039E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 955 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000955)=0.000000000000000E+00 beta (00000956)=0.135412454925569E+02 gamma(00000956)=0.135412454925569E+02 lr_calc_dens: Charge drift due to real space implementation = -0.15461E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 956 z1= 1 -.318367339644197E-03 0.000000000000000E+00 z1= 2 0.148264378199766E-03 0.000000000000000E+00 z1= 3 0.135244301794300E-02 0.000000000000000E+00 alpha(00000956)=0.000000000000000E+00 beta (00000957)=0.129325917875623E+02 gamma(00000957)=0.129325917875623E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.87371E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 957 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000957)=0.000000000000000E+00 beta (00000958)=0.135258246518181E+02 gamma(00000958)=0.135258246518181E+02 lr_calc_dens: Charge drift due to real space implementation = -0.73732E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 958 z1= 1 0.317974754003197E-03 0.000000000000000E+00 z1= 2 -.149335209361609E-03 0.000000000000000E+00 z1= 3 -.183629763440217E-02 0.000000000000000E+00 alpha(00000958)=0.000000000000000E+00 beta (00000959)=0.130121132996267E+02 gamma(00000959)=0.130121132996267E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.31634E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 959 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000959)=0.000000000000000E+00 beta (00000960)=0.135944290357597E+02 gamma(00000960)=0.135944290357597E+02 lr_calc_dens: Charge drift due to real space implementation = 0.85548E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 960 z1= 1 -.317858437188254E-03 0.000000000000000E+00 z1= 2 0.148499336619007E-03 0.000000000000000E+00 z1= 3 0.210421164812464E-02 0.000000000000000E+00 alpha(00000960)=0.000000000000000E+00 beta (00000961)=0.130173344681421E+02 gamma(00000961)=0.130173344681421E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.99162E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 961 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000961)=0.000000000000000E+00 beta (00000962)=0.135306868438080E+02 gamma(00000962)=0.135306868438080E+02 lr_calc_dens: Charge drift due to real space implementation = -0.58694E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 962 z1= 1 0.320779952235030E-03 0.000000000000000E+00 z1= 2 -.149443372491210E-03 0.000000000000000E+00 z1= 3 -.183515537012372E-02 0.000000000000000E+00 alpha(00000962)=0.000000000000000E+00 beta (00000963)=0.129418644973345E+02 gamma(00000963)=0.129418644973345E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.26042E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 963 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000963)=0.000000000000000E+00 beta (00000964)=0.134537074473141E+02 gamma(00000964)=0.134537074473141E+02 lr_calc_dens: Charge drift due to real space implementation = 0.15835E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 964 z1= 1 -.323081392599202E-03 0.000000000000000E+00 z1= 2 0.148672962966608E-03 0.000000000000000E+00 z1= 3 0.104754867384852E-02 0.000000000000000E+00 alpha(00000964)=0.000000000000000E+00 beta (00000965)=0.131027536124287E+02 gamma(00000965)=0.131027536124287E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.55048E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 965 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000965)=0.000000000000000E+00 beta (00000966)=0.134992518245633E+02 gamma(00000966)=0.134992518245633E+02 lr_calc_dens: Charge drift due to real space implementation = -0.15449E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 966 z1= 1 0.328402539680768E-03 0.000000000000000E+00 z1= 2 -.151628337922597E-03 0.000000000000000E+00 z1= 3 -.171139628265594E-03 0.000000000000000E+00 alpha(00000966)=0.000000000000000E+00 beta (00000967)=0.129165490926589E+02 gamma(00000967)=0.129165490926589E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.18762E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 967 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000967)=0.000000000000000E+00 beta (00000968)=0.134981119647647E+02 gamma(00000968)=0.134981119647647E+02 lr_calc_dens: Charge drift due to real space implementation = 0.26136E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 968 z1= 1 -.328084192806253E-03 0.000000000000000E+00 z1= 2 0.150796992074826E-03 0.000000000000000E+00 z1= 3 -.390553255018366E-03 0.000000000000000E+00 alpha(00000968)=0.000000000000000E+00 beta (00000969)=0.129106624250701E+02 gamma(00000969)=0.129106624250701E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.46984E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 969 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000969)=0.000000000000000E+00 beta (00000970)=0.134380587623068E+02 gamma(00000970)=0.134380587623068E+02 lr_calc_dens: Charge drift due to real space implementation = -0.32891E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 970 z1= 1 0.330151809414304E-03 0.000000000000000E+00 z1= 2 -.152991396841661E-03 0.000000000000000E+00 z1= 3 0.579601617616736E-03 0.000000000000000E+00 alpha(00000970)=0.000000000000000E+00 beta (00000971)=0.130107982559623E+02 gamma(00000971)=0.130107982559623E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.48653E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 971 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000971)=0.000000000000000E+00 beta (00000972)=0.134331133875245E+02 gamma(00000972)=0.134331133875245E+02 lr_calc_dens: Charge drift due to real space implementation = -0.93159E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 972 z1= 1 -.334074693159453E-03 0.000000000000000E+00 z1= 2 0.153773217154975E-03 0.000000000000000E+00 z1= 3 -.550993405993900E-03 0.000000000000000E+00 alpha(00000972)=0.000000000000000E+00 beta (00000973)=0.129230166389613E+02 gamma(00000973)=0.129230166389613E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.31879E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 973 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000973)=0.000000000000000E+00 beta (00000974)=0.136515472389037E+02 gamma(00000974)=0.136515472389037E+02 lr_calc_dens: Charge drift due to real space implementation = 0.15022E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 974 z1= 1 0.331621766271681E-03 0.000000000000000E+00 z1= 2 -.152831756708710E-03 0.000000000000000E+00 z1= 3 0.337392960345736E-03 0.000000000000000E+00 alpha(00000974)=0.000000000000000E+00 beta (00000975)=0.128641596301234E+02 gamma(00000975)=0.128641596301234E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.11445E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 975 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000975)=0.000000000000000E+00 beta (00000976)=0.135492990493993E+02 gamma(00000976)=0.135492990493993E+02 lr_calc_dens: Charge drift due to real space implementation = 0.29473E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 976 z1= 1 -.330871592856499E-03 0.000000000000000E+00 z1= 2 0.149327275046002E-03 0.000000000000000E+00 z1= 3 -.292852321358991E-03 0.000000000000000E+00 alpha(00000976)=0.000000000000000E+00 beta (00000977)=0.128641562548769E+02 gamma(00000977)=0.128641562548769E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.16702E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 977 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000977)=0.000000000000000E+00 beta (00000978)=0.135506779680853E+02 gamma(00000978)=0.135506779680853E+02 lr_calc_dens: Charge drift due to real space implementation = -0.56899E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 978 z1= 1 0.331413418949864E-03 0.000000000000000E+00 z1= 2 -.148749112630758E-03 0.000000000000000E+00 z1= 3 0.718106703428433E-03 0.000000000000000E+00 alpha(00000978)=0.000000000000000E+00 beta (00000979)=0.128501629255001E+02 gamma(00000979)=0.128501629255001E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.74061E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 979 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000979)=0.000000000000000E+00 beta (00000980)=0.136704045839172E+02 gamma(00000980)=0.136704045839172E+02 lr_calc_dens: Charge drift due to real space implementation = 0.70425E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 980 z1= 1 -.328456211732002E-03 0.000000000000000E+00 z1= 2 0.144285514498696E-03 0.000000000000000E+00 z1= 3 -.150975425840042E-02 0.000000000000000E+00 alpha(00000980)=0.000000000000000E+00 beta (00000981)=0.129394953624336E+02 gamma(00000981)=0.129394953624336E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.75924E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 981 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000981)=0.000000000000000E+00 beta (00000982)=0.134483840833308E+02 gamma(00000982)=0.134483840833308E+02 lr_calc_dens: Charge drift due to real space implementation = 0.51744E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 982 z1= 1 0.334954346841402E-03 0.000000000000000E+00 z1= 2 -.147581592472926E-03 0.000000000000000E+00 z1= 3 0.233444130184680E-02 0.000000000000000E+00 alpha(00000982)=0.000000000000000E+00 beta (00000983)=0.129533474758791E+02 gamma(00000983)=0.129533474758791E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12657E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 983 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000983)=0.000000000000000E+00 beta (00000984)=0.134750212048264E+02 gamma(00000984)=0.134750212048264E+02 lr_calc_dens: Charge drift due to real space implementation = -0.36107E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 984 z1= 1 -.340734810562183E-03 0.000000000000000E+00 z1= 2 0.145699518091641E-03 0.000000000000000E+00 z1= 3 -.275597752128658E-02 0.000000000000000E+00 alpha(00000984)=0.000000000000000E+00 beta (00000985)=0.130135599596183E+02 gamma(00000985)=0.130135599596183E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.21844E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 985 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000985)=0.000000000000000E+00 beta (00000986)=0.135459957456546E+02 gamma(00000986)=0.135459957456546E+02 lr_calc_dens: Charge drift due to real space implementation = -0.15548E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 986 z1= 1 0.347594123434045E-03 0.000000000000000E+00 z1= 2 -.148180076259798E-03 0.000000000000000E+00 z1= 3 0.281254229004823E-02 0.000000000000000E+00 alpha(00000986)=0.000000000000000E+00 beta (00000987)=0.130097960525600E+02 gamma(00000987)=0.130097960525600E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.78438E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 987 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000987)=0.000000000000000E+00 beta (00000988)=0.135626115117360E+02 gamma(00000988)=0.135626115117360E+02 lr_calc_dens: Charge drift due to real space implementation = 0.25188E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 988 z1= 1 -.352711283975369E-03 0.000000000000000E+00 z1= 2 0.145831201575448E-03 0.000000000000000E+00 z1= 3 -.274194159537498E-02 0.000000000000000E+00 alpha(00000988)=0.000000000000000E+00 beta (00000989)=0.130459906523020E+02 gamma(00000989)=0.130459906523020E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.37480E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 989 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000989)=0.000000000000000E+00 beta (00000990)=0.135622205108674E+02 gamma(00000990)=0.135622205108674E+02 lr_calc_dens: Charge drift due to real space implementation = -0.19256E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 990 z1= 1 0.359462836995897E-03 0.000000000000000E+00 z1= 2 -.150585605739836E-03 0.000000000000000E+00 z1= 3 0.284268335616168E-02 0.000000000000000E+00 alpha(00000990)=0.000000000000000E+00 beta (00000991)=0.130356624891554E+02 gamma(00000991)=0.130356624891554E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.69751E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 991 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000991)=0.000000000000000E+00 beta (00000992)=0.134439914982409E+02 gamma(00000992)=0.134439914982409E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12358E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 992 z1= 1 -.367253253328338E-03 0.000000000000000E+00 z1= 2 0.151336461155183E-03 0.000000000000000E+00 z1= 3 -.333339187528368E-02 0.000000000000000E+00 alpha(00000992)=0.000000000000000E+00 beta (00000993)=0.130304270900983E+02 gamma(00000993)=0.130304270900983E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.80499E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 993 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000993)=0.000000000000000E+00 beta (00000994)=0.135746194714710E+02 gamma(00000994)=0.135746194714710E+02 lr_calc_dens: Charge drift due to real space implementation = 0.56375E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 994 z1= 1 0.372123749898904E-03 0.000000000000000E+00 z1= 2 -.156195100378571E-03 0.000000000000000E+00 z1= 3 0.401276736794288E-02 0.000000000000000E+00 alpha(00000994)=0.000000000000000E+00 beta (00000995)=0.130506975326388E+02 gamma(00000995)=0.130506975326388E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.45006E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 995 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000995)=0.000000000000000E+00 beta (00000996)=0.134858575423504E+02 gamma(00000996)=0.134858575423504E+02 lr_calc_dens: Charge drift due to real space implementation = -0.58869E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 996 z1= 1 -.378868613869384E-03 0.000000000000000E+00 z1= 2 0.156652167524203E-03 0.000000000000000E+00 z1= 3 -.465343788543458E-02 0.000000000000000E+00 alpha(00000996)=0.000000000000000E+00 beta (00000997)=0.129989266937333E+02 gamma(00000997)=0.129989266937333E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14099E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 997 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000997)=0.000000000000000E+00 beta (00000998)=0.136413659412004E+02 gamma(00000998)=0.136413659412004E+02 lr_calc_dens: Charge drift due to real space implementation = 0.38043E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 998 z1= 1 0.381277363216516E-03 0.000000000000000E+00 z1= 2 -.160133689369869E-03 0.000000000000000E+00 z1= 3 0.495629221596495E-02 0.000000000000000E+00 alpha(00000998)=0.000000000000000E+00 beta (00000999)=0.131026319188923E+02 gamma(00000999)=0.131026319188923E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.20864E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 999 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00000999)=0.000000000000000E+00 beta (00001000)=0.136537198470268E+02 gamma(00001000)=0.136537198470268E+02 lr_calc_dens: Charge drift due to real space implementation = -0.23614E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1000 z1= 1 -.385822033578340E-03 0.000000000000000E+00 z1= 2 0.158575920002390E-03 0.000000000000000E+00 z1= 3 -.493486564649008E-02 0.000000000000000E+00 alpha(00001000)=0.000000000000000E+00 beta (00001001)=0.130671126530096E+02 gamma(00001001)=0.130671126530096E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12017E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1001 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001001)=0.000000000000000E+00 beta (00001002)=0.135357857970473E+02 gamma(00001002)=0.135357857970473E+02 lr_calc_dens: Charge drift due to real space implementation = -0.46877E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1002 z1= 1 0.394919519438997E-03 0.000000000000000E+00 z1= 2 -.163693001640364E-03 0.000000000000000E+00 z1= 3 0.460318269163196E-02 0.000000000000000E+00 alpha(00001002)=0.000000000000000E+00 beta (00001003)=0.130312241686536E+02 gamma(00001003)=0.130312241686536E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.37661E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1003 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001003)=0.000000000000000E+00 beta (00001004)=0.133552682650512E+02 gamma(00001004)=0.133552682650512E+02 lr_calc_dens: Charge drift due to real space implementation = 0.25672E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1004 z1= 1 -.407264161272949E-03 0.000000000000000E+00 z1= 2 0.165602994537286E-03 0.000000000000000E+00 z1= 3 -.433564269676140E-02 0.000000000000000E+00 alpha(00001004)=0.000000000000000E+00 beta (00001005)=0.129969389417668E+02 gamma(00001005)=0.129969389417668E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.29510E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1005 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001005)=0.000000000000000E+00 beta (00001006)=0.135380081580614E+02 gamma(00001006)=0.135380081580614E+02 lr_calc_dens: Charge drift due to real space implementation = -0.92367E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1006 z1= 1 0.413578989314684E-03 0.000000000000000E+00 z1= 2 -.169224686329915E-03 0.000000000000000E+00 z1= 3 0.439278917990960E-02 0.000000000000000E+00 alpha(00001006)=0.000000000000000E+00 beta (00001007)=0.129643785653463E+02 gamma(00001007)=0.129643785653463E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.47504E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1007 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001007)=0.000000000000000E+00 beta (00001008)=0.134624685140055E+02 gamma(00001008)=0.134624685140055E+02 lr_calc_dens: Charge drift due to real space implementation = -0.16461E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1008 z1= 1 -.420780231584531E-03 0.000000000000000E+00 z1= 2 0.169961734477735E-03 0.000000000000000E+00 z1= 3 -.478998079247723E-02 0.000000000000000E+00 alpha(00001008)=0.000000000000000E+00 beta (00001009)=0.129489974544390E+02 gamma(00001009)=0.129489974544390E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.47027E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1009 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001009)=0.000000000000000E+00 beta (00001010)=0.135127520218409E+02 gamma(00001010)=0.135127520218409E+02 lr_calc_dens: Charge drift due to real space implementation = 0.34903E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1010 z1= 1 0.426997029601233E-03 0.000000000000000E+00 z1= 2 -.173230713455351E-03 0.000000000000000E+00 z1= 3 0.528064495617750E-02 0.000000000000000E+00 alpha(00001010)=0.000000000000000E+00 beta (00001011)=0.130176007005456E+02 gamma(00001011)=0.130176007005456E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.39606E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1011 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001011)=0.000000000000000E+00 beta (00001012)=0.134489740824050E+02 gamma(00001012)=0.134489740824050E+02 lr_calc_dens: Charge drift due to real space implementation = -0.42086E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1012 z1= 1 -.437456343336444E-03 0.000000000000000E+00 z1= 2 0.175756030683983E-03 0.000000000000000E+00 z1= 3 -.574498286664003E-02 0.000000000000000E+00 alpha(00001012)=0.000000000000000E+00 beta (00001013)=0.129832896905014E+02 gamma(00001013)=0.129832896905014E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.43630E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1013 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001013)=0.000000000000000E+00 beta (00001014)=0.134641506081997E+02 gamma(00001014)=0.134641506081997E+02 lr_calc_dens: Charge drift due to real space implementation = 0.57469E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1014 z1= 1 0.446802397626597E-03 0.000000000000000E+00 z1= 2 -.178195088878173E-03 0.000000000000000E+00 z1= 3 0.586513161738300E-02 0.000000000000000E+00 alpha(00001014)=0.000000000000000E+00 beta (00001015)=0.129228529796066E+02 gamma(00001015)=0.129228529796066E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.31740E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1015 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001015)=0.000000000000000E+00 beta (00001016)=0.134802735145845E+02 gamma(00001016)=0.134802735145845E+02 lr_calc_dens: Charge drift due to real space implementation = -0.70815E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1016 z1= 1 -.453170288212792E-03 0.000000000000000E+00 z1= 2 0.179397305832486E-03 0.000000000000000E+00 z1= 3 -.557297656594680E-02 0.000000000000000E+00 alpha(00001016)=0.000000000000000E+00 beta (00001017)=0.129157420951755E+02 gamma(00001017)=0.129157420951755E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.18272E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1017 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001017)=0.000000000000000E+00 beta (00001018)=0.134534523292735E+02 gamma(00001018)=0.134534523292735E+02 lr_calc_dens: Charge drift due to real space implementation = 0.24920E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1018 z1= 1 0.461193943953841E-03 0.000000000000000E+00 z1= 2 -.180757952994488E-03 0.000000000000000E+00 z1= 3 0.496438235264441E-02 0.000000000000000E+00 alpha(00001018)=0.000000000000000E+00 beta (00001019)=0.129767614214827E+02 gamma(00001019)=0.129767614214827E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.30735E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1019 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001019)=0.000000000000000E+00 beta (00001020)=0.134767486975285E+02 gamma(00001020)=0.134767486975285E+02 lr_calc_dens: Charge drift due to real space implementation = 0.29072E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1020 z1= 1 -.470215674580486E-03 0.000000000000000E+00 z1= 2 0.183076935859612E-03 0.000000000000000E+00 z1= 3 -.435131830241422E-02 0.000000000000000E+00 alpha(00001020)=0.000000000000000E+00 beta (00001021)=0.130234079281469E+02 gamma(00001021)=0.130234079281469E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.87387E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1021 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001021)=0.000000000000000E+00 beta (00001022)=0.135315802201920E+02 gamma(00001022)=0.135315802201920E+02 lr_calc_dens: Charge drift due to real space implementation = -0.31472E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1022 z1= 1 0.479623728096972E-03 0.000000000000000E+00 z1= 2 -.184141615829105E-03 0.000000000000000E+00 z1= 3 0.408332545628542E-02 0.000000000000000E+00 alpha(00001022)=0.000000000000000E+00 beta (00001023)=0.130743430561335E+02 gamma(00001023)=0.130743430561335E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.47670E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1023 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001023)=0.000000000000000E+00 beta (00001024)=0.135053796679373E+02 gamma(00001024)=0.135053796679373E+02 lr_calc_dens: Charge drift due to real space implementation = -0.34880E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1024 z1= 1 -.491479237813681E-03 0.000000000000000E+00 z1= 2 0.187805716042442E-03 0.000000000000000E+00 z1= 3 -.425286413463561E-02 0.000000000000000E+00 alpha(00001024)=0.000000000000000E+00 beta (00001025)=0.129976969277095E+02 gamma(00001025)=0.129976969277095E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.59283E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1025 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001025)=0.000000000000000E+00 beta (00001026)=0.135543683752019E+02 gamma(00001026)=0.135543683752019E+02 lr_calc_dens: Charge drift due to real space implementation = 0.45367E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1026 z1= 1 0.499286873602119E-03 0.000000000000000E+00 z1= 2 -.188437366910799E-03 0.000000000000000E+00 z1= 3 0.462256400416000E-02 0.000000000000000E+00 alpha(00001026)=0.000000000000000E+00 beta (00001027)=0.130451928394874E+02 gamma(00001027)=0.130451928394874E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.45900E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1027 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001027)=0.000000000000000E+00 beta (00001028)=0.133977398856918E+02 gamma(00001028)=0.133977398856918E+02 lr_calc_dens: Charge drift due to real space implementation = -0.92153E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1028 z1= 1 -.514601158102469E-03 0.000000000000000E+00 z1= 2 0.195349034364564E-03 0.000000000000000E+00 z1= 3 -.502255266249811E-02 0.000000000000000E+00 alpha(00001028)=0.000000000000000E+00 beta (00001029)=0.129964739246696E+02 gamma(00001029)=0.129964739246696E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.15438E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1029 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001029)=0.000000000000000E+00 beta (00001030)=0.134515640343378E+02 gamma(00001030)=0.134515640343378E+02 lr_calc_dens: Charge drift due to real space implementation = 0.97567E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1030 z1= 1 0.525580721087398E-03 0.000000000000000E+00 z1= 2 -.197841236718601E-03 0.000000000000000E+00 z1= 3 0.508881239871416E-02 0.000000000000000E+00 alpha(00001030)=0.000000000000000E+00 beta (00001031)=0.130214118652135E+02 gamma(00001031)=0.130214118652135E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.91757E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1031 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001031)=0.000000000000000E+00 beta (00001032)=0.134421849126029E+02 gamma(00001032)=0.134421849126029E+02 lr_calc_dens: Charge drift due to real space implementation = -0.38686E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1032 z1= 1 -.536931987498053E-03 0.000000000000000E+00 z1= 2 0.205400225383855E-03 0.000000000000000E+00 z1= 3 -.472329660337598E-02 0.000000000000000E+00 alpha(00001032)=0.000000000000000E+00 beta (00001033)=0.130559766276321E+02 gamma(00001033)=0.130559766276321E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11041E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1033 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001033)=0.000000000000000E+00 beta (00001034)=0.134944658438557E+02 gamma(00001034)=0.134944658438557E+02 lr_calc_dens: Charge drift due to real space implementation = -0.22344E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1034 z1= 1 0.546858687874914E-03 0.000000000000000E+00 z1= 2 -.207202351267976E-03 0.000000000000000E+00 z1= 3 0.413056153268178E-02 0.000000000000000E+00 alpha(00001034)=0.000000000000000E+00 beta (00001035)=0.130474680806798E+02 gamma(00001035)=0.130474680806798E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.77299E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1035 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001035)=0.000000000000000E+00 beta (00001036)=0.134511101422426E+02 gamma(00001036)=0.134511101422426E+02 lr_calc_dens: Charge drift due to real space implementation = 0.45085E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1036 z1= 1 -.557703778419035E-03 0.000000000000000E+00 z1= 2 0.214065737357112E-03 0.000000000000000E+00 z1= 3 -.359843578173242E-02 0.000000000000000E+00 alpha(00001036)=0.000000000000000E+00 beta (00001037)=0.130983659763515E+02 gamma(00001037)=0.130983659763515E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.29328E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1037 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001037)=0.000000000000000E+00 beta (00001038)=0.133769621692414E+02 gamma(00001038)=0.133769621692414E+02 lr_calc_dens: Charge drift due to real space implementation = -0.27668E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1038 z1= 1 0.573350754625798E-03 0.000000000000000E+00 z1= 2 -.216729473998960E-03 0.000000000000000E+00 z1= 3 0.326697225110140E-02 0.000000000000000E+00 alpha(00001038)=0.000000000000000E+00 beta (00001039)=0.130810464823052E+02 gamma(00001039)=0.130810464823052E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.45566E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1039 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001039)=0.000000000000000E+00 beta (00001040)=0.134159535704748E+02 gamma(00001040)=0.134159535704748E+02 lr_calc_dens: Charge drift due to real space implementation = -0.16893E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1040 z1= 1 -.586145227027945E-03 0.000000000000000E+00 z1= 2 0.223813185127802E-03 0.000000000000000E+00 z1= 3 -.305817533187600E-02 0.000000000000000E+00 alpha(00001040)=0.000000000000000E+00 beta (00001041)=0.131055699750048E+02 gamma(00001041)=0.131055699750048E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.23883E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1041 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001041)=0.000000000000000E+00 beta (00001042)=0.133879949995943E+02 gamma(00001042)=0.133879949995943E+02 lr_calc_dens: Charge drift due to real space implementation = 0.56076E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1042 z1= 1 0.600927637516954E-03 0.000000000000000E+00 z1= 2 -.224083946338937E-03 0.000000000000000E+00 z1= 3 0.291912711984386E-02 0.000000000000000E+00 alpha(00001042)=0.000000000000000E+00 beta (00001043)=0.130100988631520E+02 gamma(00001043)=0.130100988631520E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.55379E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1043 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001043)=0.000000000000000E+00 beta (00001044)=0.133456111692310E+02 gamma(00001044)=0.133456111692310E+02 lr_calc_dens: Charge drift due to real space implementation = -0.44058E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1044 z1= 1 -.613751556618505E-03 0.000000000000000E+00 z1= 2 0.229341007819512E-03 0.000000000000000E+00 z1= 3 -.271284560496493E-02 0.000000000000000E+00 alpha(00001044)=0.000000000000000E+00 beta (00001045)=0.131533361347786E+02 gamma(00001045)=0.131533361347786E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.96803E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1045 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001045)=0.000000000000000E+00 beta (00001046)=0.133567564081030E+02 gamma(00001046)=0.133567564081030E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12378E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1046 z1= 1 0.632301674060673E-03 0.000000000000000E+00 z1= 2 -.229720476817552E-03 0.000000000000000E+00 z1= 3 0.234226768029931E-02 0.000000000000000E+00 alpha(00001046)=0.000000000000000E+00 beta (00001047)=0.129576615321694E+02 gamma(00001047)=0.129576615321694E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13259E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1047 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001047)=0.000000000000000E+00 beta (00001048)=0.133620800557235E+02 gamma(00001048)=0.133620800557235E+02 lr_calc_dens: Charge drift due to real space implementation = 0.42903E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1048 z1= 1 -.641523237275327E-03 0.000000000000000E+00 z1= 2 0.234491207703292E-03 0.000000000000000E+00 z1= 3 -.181409566060732E-02 0.000000000000000E+00 alpha(00001048)=0.000000000000000E+00 beta (00001049)=0.130987908272606E+02 gamma(00001049)=0.130987908272606E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12606E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1049 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001049)=0.000000000000000E+00 beta (00001050)=0.134066306667387E+02 gamma(00001050)=0.134066306667387E+02 lr_calc_dens: Charge drift due to real space implementation = -0.85723E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1050 z1= 1 0.653724817256200E-03 0.000000000000000E+00 z1= 2 -.231377581371392E-03 0.000000000000000E+00 z1= 3 0.141016140061140E-02 0.000000000000000E+00 alpha(00001050)=0.000000000000000E+00 beta (00001051)=0.131301932794195E+02 gamma(00001051)=0.131301932794195E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.63943E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1051 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001051)=0.000000000000000E+00 beta (00001052)=0.134341966512353E+02 gamma(00001052)=0.134341966512353E+02 lr_calc_dens: Charge drift due to real space implementation = 0.47928E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1052 z1= 1 -.665191357729476E-03 0.000000000000000E+00 z1= 2 0.238060778154923E-03 0.000000000000000E+00 z1= 3 -.126399430638851E-02 0.000000000000000E+00 alpha(00001052)=0.000000000000000E+00 beta (00001053)=0.130081999486390E+02 gamma(00001053)=0.130081999486390E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.35039E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1053 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001053)=0.000000000000000E+00 beta (00001054)=0.134868468465358E+02 gamma(00001054)=0.134868468465358E+02 lr_calc_dens: Charge drift due to real space implementation = 0.26292E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1054 z1= 1 0.666771186991953E-03 0.000000000000000E+00 z1= 2 -.230821533177080E-03 0.000000000000000E+00 z1= 3 0.126974557695980E-02 0.000000000000000E+00 alpha(00001054)=0.000000000000000E+00 beta (00001055)=0.130962524799691E+02 gamma(00001055)=0.130962524799691E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.85078E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1055 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001055)=0.000000000000000E+00 beta (00001056)=0.134632663091547E+02 gamma(00001056)=0.134632663091547E+02 lr_calc_dens: Charge drift due to real space implementation = -0.33203E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1056 z1= 1 -.673986577656222E-03 0.000000000000000E+00 z1= 2 0.238280182656524E-03 0.000000000000000E+00 z1= 3 -.118376018440335E-02 0.000000000000000E+00 alpha(00001056)=0.000000000000000E+00 beta (00001057)=0.131263087404040E+02 gamma(00001057)=0.131263087404040E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.13186E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1057 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001057)=0.000000000000000E+00 beta (00001058)=0.135300679223199E+02 gamma(00001058)=0.135300679223199E+02 lr_calc_dens: Charge drift due to real space implementation = -0.17917E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1058 z1= 1 0.678022632391941E-03 0.000000000000000E+00 z1= 2 -.231876973734146E-03 0.000000000000000E+00 z1= 3 0.773458185204433E-03 0.000000000000000E+00 alpha(00001058)=0.000000000000000E+00 beta (00001059)=0.130712056406394E+02 gamma(00001059)=0.130712056406394E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12389E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1059 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001059)=0.000000000000000E+00 beta (00001060)=0.134373187846761E+02 gamma(00001060)=0.134373187846761E+02 lr_calc_dens: Charge drift due to real space implementation = 0.65753E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1060 z1= 1 -.684779033587794E-03 0.000000000000000E+00 z1= 2 0.240412865927858E-03 0.000000000000000E+00 z1= 3 -.134717246592211E-03 0.000000000000000E+00 alpha(00001060)=0.000000000000000E+00 beta (00001061)=0.131092344093755E+02 gamma(00001061)=0.131092344093755E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.72021E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1061 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001061)=0.000000000000000E+00 beta (00001062)=0.134451975064812E+02 gamma(00001062)=0.134451975064812E+02 lr_calc_dens: Charge drift due to real space implementation = -0.60126E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1062 z1= 1 0.692030103951628E-03 0.000000000000000E+00 z1= 2 -.234945234636273E-03 0.000000000000000E+00 z1= 3 -.436871288221617E-03 0.000000000000000E+00 alpha(00001062)=0.000000000000000E+00 beta (00001063)=0.131233234999793E+02 gamma(00001063)=0.131233234999793E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.39691E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1063 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001063)=0.000000000000000E+00 beta (00001064)=0.134359217763546E+02 gamma(00001064)=0.134359217763546E+02 lr_calc_dens: Charge drift due to real space implementation = 0.23065E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1064 z1= 1 -.701185729806029E-03 0.000000000000000E+00 z1= 2 0.244984896599843E-03 0.000000000000000E+00 z1= 3 0.864152953665960E-03 0.000000000000000E+00 alpha(00001064)=0.000000000000000E+00 beta (00001065)=0.130645278788512E+02 gamma(00001065)=0.130645278788512E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.63033E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1065 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001065)=0.000000000000000E+00 beta (00001066)=0.133901500245827E+02 gamma(00001066)=0.133901500245827E+02 lr_calc_dens: Charge drift due to real space implementation = -0.23108E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1066 z1= 1 0.708177415603445E-03 0.000000000000000E+00 z1= 2 -.239352171006889E-03 0.000000000000000E+00 z1= 3 -.117107255730554E-02 0.000000000000000E+00 alpha(00001066)=0.000000000000000E+00 beta (00001067)=0.132416312511801E+02 gamma(00001067)=0.132416312511801E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.85347E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1067 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001067)=0.000000000000000E+00 beta (00001068)=0.133674699702672E+02 gamma(00001068)=0.133674699702672E+02 lr_calc_dens: Charge drift due to real space implementation = 0.49856E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1068 z1= 1 -.725419517906748E-03 0.000000000000000E+00 z1= 2 0.250862805481648E-03 0.000000000000000E+00 z1= 3 0.142935918478824E-02 0.000000000000000E+00 alpha(00001068)=0.000000000000000E+00 beta (00001069)=0.131031408200638E+02 gamma(00001069)=0.131031408200638E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.70330E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1069 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001069)=0.000000000000000E+00 beta (00001070)=0.133236039532494E+02 gamma(00001070)=0.133236039532494E+02 lr_calc_dens: Charge drift due to real space implementation = -0.43486E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1070 z1= 1 0.735459372092901E-03 0.000000000000000E+00 z1= 2 -.246132217925047E-03 0.000000000000000E+00 z1= 3 -.165962208422896E-02 0.000000000000000E+00 alpha(00001070)=0.000000000000000E+00 beta (00001071)=0.132511994568273E+02 gamma(00001071)=0.132511994568273E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.59303E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1071 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001071)=0.000000000000000E+00 beta (00001072)=0.133997267761790E+02 gamma(00001072)=0.133997267761790E+02 lr_calc_dens: Charge drift due to real space implementation = 0.70768E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1072 z1= 1 -.749370030626521E-03 0.000000000000000E+00 z1= 2 0.255776598836292E-03 0.000000000000000E+00 z1= 3 0.189936961575710E-02 0.000000000000000E+00 alpha(00001072)=0.000000000000000E+00 beta (00001073)=0.130797156810650E+02 gamma(00001073)=0.130797156810650E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.96776E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1073 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001073)=0.000000000000000E+00 beta (00001074)=0.134025179525650E+02 gamma(00001074)=0.134025179525650E+02 lr_calc_dens: Charge drift due to real space implementation = -0.68113E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1074 z1= 1 0.751901624656453E-03 0.000000000000000E+00 z1= 2 -.248599144616394E-03 0.000000000000000E+00 z1= 3 -.225456257424688E-02 0.000000000000000E+00 alpha(00001074)=0.000000000000000E+00 beta (00001075)=0.130645351869979E+02 gamma(00001075)=0.130645351869979E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13682E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1075 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001075)=0.000000000000000E+00 beta (00001076)=0.134645022973542E+02 gamma(00001076)=0.134645022973542E+02 lr_calc_dens: Charge drift due to real space implementation = 0.56096E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1076 z1= 1 -.750942110414625E-03 0.000000000000000E+00 z1= 2 0.251402961072855E-03 0.000000000000000E+00 z1= 3 0.270378978979659E-02 0.000000000000000E+00 alpha(00001076)=0.000000000000000E+00 beta (00001077)=0.130019544874857E+02 gamma(00001077)=0.130019544874857E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11991E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1077 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001077)=0.000000000000000E+00 beta (00001078)=0.134120768399085E+02 gamma(00001078)=0.134120768399085E+02 lr_calc_dens: Charge drift due to real space implementation = -0.86928E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1078 z1= 1 0.747497412807810E-03 0.000000000000000E+00 z1= 2 -.243304400073945E-03 0.000000000000000E+00 z1= 3 -.309044521535476E-02 0.000000000000000E+00 alpha(00001078)=0.000000000000000E+00 beta (00001079)=0.131025041243163E+02 gamma(00001079)=0.131025041243163E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.72099E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1079 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001079)=0.000000000000000E+00 beta (00001080)=0.134837906384321E+02 gamma(00001080)=0.134837906384321E+02 lr_calc_dens: Charge drift due to real space implementation = 0.75913E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1080 z1= 1 -.746065261225855E-03 0.000000000000000E+00 z1= 2 0.246520483823524E-03 0.000000000000000E+00 z1= 3 0.340990743897948E-02 0.000000000000000E+00 alpha(00001080)=0.000000000000000E+00 beta (00001081)=0.130556843856578E+02 gamma(00001081)=0.130556843856578E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.35420E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1081 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001081)=0.000000000000000E+00 beta (00001082)=0.133399557029969E+02 gamma(00001082)=0.133399557029969E+02 lr_calc_dens: Charge drift due to real space implementation = -0.34878E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1082 z1= 1 0.748119990527544E-03 0.000000000000000E+00 z1= 2 -.241818240528673E-03 0.000000000000000E+00 z1= 3 -.375460282620600E-02 0.000000000000000E+00 alpha(00001082)=0.000000000000000E+00 beta (00001083)=0.131608501616736E+02 gamma(00001083)=0.131608501616736E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.43458E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1083 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001083)=0.000000000000000E+00 beta (00001084)=0.134364728244769E+02 gamma(00001084)=0.134364728244769E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11157E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1084 z1= 1 -.751454089226032E-03 0.000000000000000E+00 z1= 2 0.246390252241437E-03 0.000000000000000E+00 z1= 3 0.418464790116304E-02 0.000000000000000E+00 alpha(00001084)=0.000000000000000E+00 beta (00001085)=0.130209188779578E+02 gamma(00001085)=0.130209188779578E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.85146E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1085 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001085)=0.000000000000000E+00 beta (00001086)=0.134224555778480E+02 gamma(00001086)=0.134224555778480E+02 lr_calc_dens: Charge drift due to real space implementation = -0.29834E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1086 z1= 1 0.746372644454705E-03 0.000000000000000E+00 z1= 2 -.239729959363961E-03 0.000000000000000E+00 z1= 3 -.478415513041628E-02 0.000000000000000E+00 alpha(00001086)=0.000000000000000E+00 beta (00001087)=0.131111951615100E+02 gamma(00001087)=0.131111951615100E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12359E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1087 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001087)=0.000000000000000E+00 beta (00001088)=0.135350637225302E+02 gamma(00001088)=0.135350637225302E+02 lr_calc_dens: Charge drift due to real space implementation = 0.83661E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1088 z1= 1 -.741097315490520E-03 0.000000000000000E+00 z1= 2 0.240392271390322E-03 0.000000000000000E+00 z1= 3 0.537658504489778E-02 0.000000000000000E+00 alpha(00001088)=0.000000000000000E+00 beta (00001089)=0.130201379643787E+02 gamma(00001089)=0.130201379643787E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12239E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1089 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001089)=0.000000000000000E+00 beta (00001090)=0.134952066872793E+02 gamma(00001090)=0.134952066872793E+02 lr_calc_dens: Charge drift due to real space implementation = -0.13167E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1090 z1= 1 0.731056862521968E-03 0.000000000000000E+00 z1= 2 -.232775426553144E-03 0.000000000000000E+00 z1= 3 -.555909038707377E-02 0.000000000000000E+00 alpha(00001090)=0.000000000000000E+00 beta (00001091)=0.130843228470979E+02 gamma(00001091)=0.130843228470979E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.75002E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1091 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001091)=0.000000000000000E+00 beta (00001092)=0.134388234246825E+02 gamma(00001092)=0.134388234246825E+02 lr_calc_dens: Charge drift due to real space implementation = 0.14165E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1092 z1= 1 -.728703076869558E-03 0.000000000000000E+00 z1= 2 0.233886318704490E-03 0.000000000000000E+00 z1= 3 0.526946245633934E-02 0.000000000000000E+00 alpha(00001092)=0.000000000000000E+00 beta (00001093)=0.131956745305298E+02 gamma(00001093)=0.131956745305298E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.66573E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1093 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001093)=0.000000000000000E+00 beta (00001094)=0.132796232124639E+02 gamma(00001094)=0.132796232124639E+02 lr_calc_dens: Charge drift due to real space implementation = -0.87117E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1094 z1= 1 0.739158337762613E-03 0.000000000000000E+00 z1= 2 -.233693565309256E-03 0.000000000000000E+00 z1= 3 -.475305520657453E-02 0.000000000000000E+00 alpha(00001094)=0.000000000000000E+00 beta (00001095)=0.130812965764397E+02 gamma(00001095)=0.130812965764397E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11556E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1095 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001095)=0.000000000000000E+00 beta (00001096)=0.133983622877714E+02 gamma(00001096)=0.133983622877714E+02 lr_calc_dens: Charge drift due to real space implementation = 0.18961E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1096 z1= 1 -.737782417458545E-03 0.000000000000000E+00 z1= 2 0.234257018081668E-03 0.000000000000000E+00 z1= 3 0.414090595350080E-02 0.000000000000000E+00 alpha(00001096)=0.000000000000000E+00 beta (00001097)=0.130537792014622E+02 gamma(00001097)=0.130537792014622E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.27739E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1097 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001097)=0.000000000000000E+00 beta (00001098)=0.133436066061434E+02 gamma(00001098)=0.133436066061434E+02 lr_calc_dens: Charge drift due to real space implementation = 0.22157E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1098 z1= 1 0.735956593427236E-03 0.000000000000000E+00 z1= 2 -.231899056501192E-03 0.000000000000000E+00 z1= 3 -.382899983011736E-02 0.000000000000000E+00 alpha(00001098)=0.000000000000000E+00 beta (00001099)=0.130557745786557E+02 gamma(00001099)=0.130557745786557E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.76178E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1099 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001099)=0.000000000000000E+00 beta (00001100)=0.133716280237028E+02 gamma(00001100)=0.133716280237028E+02 lr_calc_dens: Charge drift due to real space implementation = 0.22816E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1100 z1= 1 -.733600859447205E-03 0.000000000000000E+00 z1= 2 0.230853166154882E-03 0.000000000000000E+00 z1= 3 0.390190826259006E-02 0.000000000000000E+00 alpha(00001100)=0.000000000000000E+00 beta (00001101)=0.130253489071099E+02 gamma(00001101)=0.130253489071099E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11365E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1101 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001101)=0.000000000000000E+00 beta (00001102)=0.135619408335904E+02 gamma(00001102)=0.135619408335904E+02 lr_calc_dens: Charge drift due to real space implementation = -0.92079E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1102 z1= 1 0.717198730025978E-03 0.000000000000000E+00 z1= 2 -.224109327993109E-03 0.000000000000000E+00 z1= 3 -.412367365267987E-02 0.000000000000000E+00 alpha(00001102)=0.000000000000000E+00 beta (00001103)=0.130686757310636E+02 gamma(00001103)=0.130686757310636E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10022E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1103 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001103)=0.000000000000000E+00 beta (00001104)=0.133667561896624E+02 gamma(00001104)=0.133667561896624E+02 lr_calc_dens: Charge drift due to real space implementation = 0.15472E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1104 z1= 1 -.714337127460921E-03 0.000000000000000E+00 z1= 2 0.221444555639595E-03 0.000000000000000E+00 z1= 3 0.435118327420880E-02 0.000000000000000E+00 alpha(00001104)=0.000000000000000E+00 beta (00001105)=0.130735331706490E+02 gamma(00001105)=0.130735331706490E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.28635E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1105 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001105)=0.000000000000000E+00 beta (00001106)=0.133907772275029E+02 gamma(00001106)=0.133907772275029E+02 lr_calc_dens: Charge drift due to real space implementation = -0.13332E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1106 z1= 1 0.707349792615226E-03 0.000000000000000E+00 z1= 2 -.220119175361166E-03 0.000000000000000E+00 z1= 3 -.420244911203641E-02 0.000000000000000E+00 alpha(00001106)=0.000000000000000E+00 beta (00001107)=0.131784362675568E+02 gamma(00001107)=0.131784362675568E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12868E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1107 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001107)=0.000000000000000E+00 beta (00001108)=0.134885623252429E+02 gamma(00001108)=0.134885623252429E+02 lr_calc_dens: Charge drift due to real space implementation = 0.75324E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1108 z1= 1 -.701341578611842E-03 0.000000000000000E+00 z1= 2 0.217445959369051E-03 0.000000000000000E+00 z1= 3 0.367520229107185E-02 0.000000000000000E+00 alpha(00001108)=0.000000000000000E+00 beta (00001109)=0.130265975797577E+02 gamma(00001109)=0.130265975797577E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.19414E-10 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1109 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001109)=0.000000000000000E+00 beta (00001110)=0.135428329805838E+02 gamma(00001110)=0.135428329805838E+02 lr_calc_dens: Charge drift due to real space implementation = -0.43970E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1110 z1= 1 0.682758254524433E-03 0.000000000000000E+00 z1= 2 -.214222714580784E-03 0.000000000000000E+00 z1= 3 -.299564760642823E-02 0.000000000000000E+00 alpha(00001110)=0.000000000000000E+00 beta (00001111)=0.129485005375238E+02 gamma(00001111)=0.129485005375238E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.23652E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1111 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001111)=0.000000000000000E+00 beta (00001112)=0.135071429944398E+02 gamma(00001112)=0.135071429944398E+02 lr_calc_dens: Charge drift due to real space implementation = 0.45200E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1112 z1= 1 -.664595886109533E-03 0.000000000000000E+00 z1= 2 0.207225243634577E-03 0.000000000000000E+00 z1= 3 0.237802321966076E-02 0.000000000000000E+00 alpha(00001112)=0.000000000000000E+00 beta (00001113)=0.130756179270173E+02 gamma(00001113)=0.130756179270173E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.29194E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1113 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001113)=0.000000000000000E+00 beta (00001114)=0.134958976587643E+02 gamma(00001114)=0.134958976587643E+02 lr_calc_dens: Charge drift due to real space implementation = -0.58569E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1114 z1= 1 0.652693289028958E-03 0.000000000000000E+00 z1= 2 -.207022828846866E-03 0.000000000000000E+00 z1= 3 -.196244043971656E-02 0.000000000000000E+00 alpha(00001114)=0.000000000000000E+00 beta (00001115)=0.130287905393526E+02 gamma(00001115)=0.130287905393526E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.20649E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1115 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001115)=0.000000000000000E+00 beta (00001116)=0.135070664605424E+02 gamma(00001116)=0.135070664605424E+02 lr_calc_dens: Charge drift due to real space implementation = 0.74864E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1116 z1= 1 -.640129354473298E-03 0.000000000000000E+00 z1= 2 0.200982642034862E-03 0.000000000000000E+00 z1= 3 0.175142222127508E-02 0.000000000000000E+00 alpha(00001116)=0.000000000000000E+00 beta (00001117)=0.130568051265054E+02 gamma(00001117)=0.130568051265054E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.30553E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1117 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001117)=0.000000000000000E+00 beta (00001118)=0.134300459440210E+02 gamma(00001118)=0.134300459440210E+02 lr_calc_dens: Charge drift due to real space implementation = -0.72519E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1118 z1= 1 0.631479848058804E-03 0.000000000000000E+00 z1= 2 -.201766526129230E-03 0.000000000000000E+00 z1= 3 -.167652609508138E-02 0.000000000000000E+00 alpha(00001118)=0.000000000000000E+00 beta (00001119)=0.130141958986823E+02 gamma(00001119)=0.130141958986823E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.18575E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1119 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001119)=0.000000000000000E+00 beta (00001120)=0.134609446519427E+02 gamma(00001120)=0.134609446519427E+02 lr_calc_dens: Charge drift due to real space implementation = 0.56898E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1120 z1= 1 -.620534515427550E-03 0.000000000000000E+00 z1= 2 0.195955213753951E-03 0.000000000000000E+00 z1= 3 0.155478897824441E-02 0.000000000000000E+00 alpha(00001120)=0.000000000000000E+00 beta (00001121)=0.130783975738541E+02 gamma(00001121)=0.130783975738541E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.80831E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1121 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001121)=0.000000000000000E+00 beta (00001122)=0.135108883247695E+02 gamma(00001122)=0.135108883247695E+02 lr_calc_dens: Charge drift due to real space implementation = -0.62979E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1122 z1= 1 0.608583545135285E-03 0.000000000000000E+00 z1= 2 -.196797238698266E-03 0.000000000000000E+00 z1= 3 -.129677735124836E-02 0.000000000000000E+00 alpha(00001122)=0.000000000000000E+00 beta (00001123)=0.130541549092259E+02 gamma(00001123)=0.130541549092259E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.91329E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1123 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001123)=0.000000000000000E+00 beta (00001124)=0.134710373704344E+02 gamma(00001124)=0.134710373704344E+02 lr_calc_dens: Charge drift due to real space implementation = 0.70563E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1124 z1= 1 -.597808000856357E-03 0.000000000000000E+00 z1= 2 0.189999352170913E-03 0.000000000000000E+00 z1= 3 0.906320682725587E-03 0.000000000000000E+00 alpha(00001124)=0.000000000000000E+00 beta (00001125)=0.131159762164048E+02 gamma(00001125)=0.131159762164048E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.32762E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1125 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001125)=0.000000000000000E+00 beta (00001126)=0.134355032781136E+02 gamma(00001126)=0.134355032781136E+02 lr_calc_dens: Charge drift due to real space implementation = -0.41012E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1126 z1= 1 0.589456130398654E-03 0.000000000000000E+00 z1= 2 -.191506973095152E-03 0.000000000000000E+00 z1= 3 -.405406870293314E-03 0.000000000000000E+00 alpha(00001126)=0.000000000000000E+00 beta (00001127)=0.130995613695058E+02 gamma(00001127)=0.130995613695058E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.32039E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1127 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001127)=0.000000000000000E+00 beta (00001128)=0.134587581991066E+02 gamma(00001128)=0.134587581991066E+02 lr_calc_dens: Charge drift due to real space implementation = 0.35508E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1128 z1= 1 -.580093614200271E-03 0.000000000000000E+00 z1= 2 0.184114248601384E-03 0.000000000000000E+00 z1= 3 -.119155802532155E-03 0.000000000000000E+00 alpha(00001128)=0.000000000000000E+00 beta (00001129)=0.130524344188729E+02 gamma(00001129)=0.130524344188729E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.13625E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1129 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001129)=0.000000000000000E+00 beta (00001130)=0.133941887127318E+02 gamma(00001130)=0.133941887127318E+02 lr_calc_dens: Charge drift due to real space implementation = -0.27122E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1130 z1= 1 0.570812681364531E-03 0.000000000000000E+00 z1= 2 -.183758517713541E-03 0.000000000000000E+00 z1= 3 0.440371699722965E-03 0.000000000000000E+00 alpha(00001130)=0.000000000000000E+00 beta (00001131)=0.130364682919770E+02 gamma(00001131)=0.130364682919770E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.20219E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1131 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001131)=0.000000000000000E+00 beta (00001132)=0.133968113764592E+02 gamma(00001132)=0.133968113764592E+02 lr_calc_dens: Charge drift due to real space implementation = 0.58533E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1132 z1= 1 -.561390226162170E-03 0.000000000000000E+00 z1= 2 0.176450673545095E-03 0.000000000000000E+00 z1= 3 -.499326945972798E-03 0.000000000000000E+00 alpha(00001132)=0.000000000000000E+00 beta (00001133)=0.130873341546584E+02 gamma(00001133)=0.130873341546584E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10645E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1133 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001133)=0.000000000000000E+00 beta (00001134)=0.134987054124857E+02 gamma(00001134)=0.134987054124857E+02 lr_calc_dens: Charge drift due to real space implementation = -0.59128E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1134 z1= 1 0.549392405070652E-03 0.000000000000000E+00 z1= 2 -.174596629943680E-03 0.000000000000000E+00 z1= 3 0.514233947917573E-03 0.000000000000000E+00 alpha(00001134)=0.000000000000000E+00 beta (00001135)=0.131074267146650E+02 gamma(00001135)=0.131074267146650E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.45788E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1135 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001135)=0.000000000000000E+00 beta (00001136)=0.133953966741385E+02 gamma(00001136)=0.133953966741385E+02 lr_calc_dens: Charge drift due to real space implementation = 0.27769E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1136 z1= 1 -.542688094429984E-03 0.000000000000000E+00 z1= 2 0.168176324144256E-03 0.000000000000000E+00 z1= 3 -.545936496414778E-03 0.000000000000000E+00 alpha(00001136)=0.000000000000000E+00 beta (00001137)=0.129637253906339E+02 gamma(00001137)=0.129637253906339E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.53207E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1137 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001137)=0.000000000000000E+00 beta (00001138)=0.135109610271798E+02 gamma(00001138)=0.135109610271798E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10821E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1138 z1= 1 0.524833959277094E-03 0.000000000000000E+00 z1= 2 -.164181550097377E-03 0.000000000000000E+00 z1= 3 0.627645189019995E-03 0.000000000000000E+00 alpha(00001138)=0.000000000000000E+00 beta (00001139)=0.130399460314365E+02 gamma(00001139)=0.130399460314365E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.19391E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1139 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001139)=0.000000000000000E+00 beta (00001140)=0.135169944352367E+02 gamma(00001140)=0.135169944352367E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10347E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1140 z1= 1 -.509903168851026E-03 0.000000000000000E+00 z1= 2 0.156099544674136E-03 0.000000000000000E+00 z1= 3 -.836472477659633E-03 0.000000000000000E+00 alpha(00001140)=0.000000000000000E+00 beta (00001141)=0.129827860099272E+02 gamma(00001141)=0.129827860099272E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.89867E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1141 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001141)=0.000000000000000E+00 beta (00001142)=0.135607472563658E+02 gamma(00001142)=0.135607472563658E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10370E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1142 z1= 1 0.490860639621262E-03 0.000000000000000E+00 z1= 2 -.150393460086748E-03 0.000000000000000E+00 z1= 3 0.109937022574780E-02 0.000000000000000E+00 alpha(00001142)=0.000000000000000E+00 beta (00001143)=0.130062135775483E+02 gamma(00001143)=0.130062135775483E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.19657E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1143 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001143)=0.000000000000000E+00 beta (00001144)=0.135121221742921E+02 gamma(00001144)=0.135121221742921E+02 lr_calc_dens: Charge drift due to real space implementation = 0.41012E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1144 z1= 1 -.473994824022814E-03 0.000000000000000E+00 z1= 2 0.139383675586449E-03 0.000000000000000E+00 z1= 3 -.139387295244540E-02 0.000000000000000E+00 alpha(00001144)=0.000000000000000E+00 beta (00001145)=0.131091008533240E+02 gamma(00001145)=0.131091008533240E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.44473E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1145 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001145)=0.000000000000000E+00 beta (00001146)=0.134528856568778E+02 gamma(00001146)=0.134528856568778E+02 lr_calc_dens: Charge drift due to real space implementation = -0.61827E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1146 z1= 1 0.462354093876079E-03 0.000000000000000E+00 z1= 2 -.135311003352056E-03 0.000000000000000E+00 z1= 3 0.179307528159044E-02 0.000000000000000E+00 alpha(00001146)=0.000000000000000E+00 beta (00001147)=0.130752479576500E+02 gamma(00001147)=0.130752479576500E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.39161E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1147 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001147)=0.000000000000000E+00 beta (00001148)=0.134086602711231E+02 gamma(00001148)=0.134086602711231E+02 lr_calc_dens: Charge drift due to real space implementation = 0.35468E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1148 z1= 1 -.450036334205104E-03 0.000000000000000E+00 z1= 2 0.127852051030802E-03 0.000000000000000E+00 z1= 3 -.230098709962742E-02 0.000000000000000E+00 alpha(00001148)=0.000000000000000E+00 beta (00001149)=0.130087709399548E+02 gamma(00001149)=0.130087709399548E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.66688E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1149 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001149)=0.000000000000000E+00 beta (00001150)=0.135635959788013E+02 gamma(00001150)=0.135635959788013E+02 lr_calc_dens: Charge drift due to real space implementation = 0.24378E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1150 z1= 1 0.429484879004851E-03 0.000000000000000E+00 z1= 2 -.122609623296040E-03 0.000000000000000E+00 z1= 3 0.263733759575011E-02 0.000000000000000E+00 alpha(00001150)=0.000000000000000E+00 beta (00001151)=0.130001957835705E+02 gamma(00001151)=0.130001957835705E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.39662E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1151 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001151)=0.000000000000000E+00 beta (00001152)=0.133683021635426E+02 gamma(00001152)=0.133683021635426E+02 lr_calc_dens: Charge drift due to real space implementation = -0.60483E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1152 z1= 1 -.414427162438636E-03 0.000000000000000E+00 z1= 2 0.115028435278665E-03 0.000000000000000E+00 z1= 3 -.283616289632385E-02 0.000000000000000E+00 alpha(00001152)=0.000000000000000E+00 beta (00001153)=0.131438463603635E+02 gamma(00001153)=0.131438463603635E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.25227E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1153 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001153)=0.000000000000000E+00 beta (00001154)=0.134706889095131E+02 gamma(00001154)=0.134706889095131E+02 lr_calc_dens: Charge drift due to real space implementation = 0.26183E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1154 z1= 1 0.400970955087194E-03 0.000000000000000E+00 z1= 2 -.110545824659782E-03 0.000000000000000E+00 z1= 3 0.287546683186620E-02 0.000000000000000E+00 alpha(00001154)=0.000000000000000E+00 beta (00001155)=0.129390005627358E+02 gamma(00001155)=0.129390005627358E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.47705E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1155 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001155)=0.000000000000000E+00 beta (00001156)=0.135113977144784E+02 gamma(00001156)=0.135113977144784E+02 lr_calc_dens: Charge drift due to real space implementation = 0.21724E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1156 z1= 1 -.379413217780185E-03 0.000000000000000E+00 z1= 2 0.101544504314335E-03 0.000000000000000E+00 z1= 3 -.274906678682797E-02 0.000000000000000E+00 alpha(00001156)=0.000000000000000E+00 beta (00001157)=0.132437410204432E+02 gamma(00001157)=0.132437410204432E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.23367E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1157 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001157)=0.000000000000000E+00 beta (00001158)=0.133884569152125E+02 gamma(00001158)=0.133884569152125E+02 lr_calc_dens: Charge drift due to real space implementation = -0.37926E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1158 z1= 1 0.370271334478812E-03 0.000000000000000E+00 z1= 2 -.976038694868037E-04 0.000000000000000E+00 z1= 3 0.277885744447301E-02 0.000000000000000E+00 alpha(00001158)=0.000000000000000E+00 beta (00001159)=0.131134680531992E+02 gamma(00001159)=0.131134680531992E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.17389E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1159 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001159)=0.000000000000000E+00 beta (00001160)=0.133492398402117E+02 gamma(00001160)=0.133492398402117E+02 lr_calc_dens: Charge drift due to real space implementation = 0.61351E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1160 z1= 1 -.357653136756489E-03 0.000000000000000E+00 z1= 2 0.918385947979491E-04 0.000000000000000E+00 z1= 3 -.289784481074365E-02 0.000000000000000E+00 alpha(00001160)=0.000000000000000E+00 beta (00001161)=0.131324510103299E+02 gamma(00001161)=0.131324510103299E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.21175E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1161 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001161)=0.000000000000000E+00 beta (00001162)=0.134031114017351E+02 gamma(00001162)=0.134031114017351E+02 lr_calc_dens: Charge drift due to real space implementation = 0.37824E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1162 z1= 1 0.344134099142098E-03 0.000000000000000E+00 z1= 2 -.867202659252317E-04 0.000000000000000E+00 z1= 3 0.310008190375261E-02 0.000000000000000E+00 alpha(00001162)=0.000000000000000E+00 beta (00001163)=0.131660901916369E+02 gamma(00001163)=0.131660901916369E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.32246E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1163 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001163)=0.000000000000000E+00 beta (00001164)=0.133907704061585E+02 gamma(00001164)=0.133907704061585E+02 lr_calc_dens: Charge drift due to real space implementation = -0.14375E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1164 z1= 1 -.331125957108461E-03 0.000000000000000E+00 z1= 2 0.817733318590735E-04 0.000000000000000E+00 z1= 3 -.331913113095920E-02 0.000000000000000E+00 alpha(00001164)=0.000000000000000E+00 beta (00001165)=0.132347874992254E+02 gamma(00001165)=0.132347874992254E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.53971E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1165 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001165)=0.000000000000000E+00 beta (00001166)=0.133209699283726E+02 gamma(00001166)=0.133209699283726E+02 lr_calc_dens: Charge drift due to real space implementation = -0.33567E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1166 z1= 1 0.321569844547483E-03 0.000000000000000E+00 z1= 2 -.764152536677342E-04 0.000000000000000E+00 z1= 3 0.364192244561184E-02 0.000000000000000E+00 alpha(00001166)=0.000000000000000E+00 beta (00001167)=0.131284584043762E+02 gamma(00001167)=0.131284584043762E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10476E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1167 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001167)=0.000000000000000E+00 beta (00001168)=0.133948135402264E+02 gamma(00001168)=0.133948135402264E+02 lr_calc_dens: Charge drift due to real space implementation = 0.16805E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1168 z1= 1 -.306815088208921E-03 0.000000000000000E+00 z1= 2 0.699114076181256E-04 0.000000000000000E+00 z1= 3 -.403250169511001E-02 0.000000000000000E+00 alpha(00001168)=0.000000000000000E+00 beta (00001169)=0.132089307611044E+02 gamma(00001169)=0.132089307611044E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10831E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1169 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001169)=0.000000000000000E+00 beta (00001170)=0.134178280798924E+02 gamma(00001170)=0.134178280798924E+02 lr_calc_dens: Charge drift due to real space implementation = 0.28651E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1170 z1= 1 0.293050297725996E-03 0.000000000000000E+00 z1= 2 -.615909661239519E-04 0.000000000000000E+00 z1= 3 0.425580551842189E-02 0.000000000000000E+00 alpha(00001170)=0.000000000000000E+00 beta (00001171)=0.131733341780433E+02 gamma(00001171)=0.131733341780433E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.30706E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1171 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001171)=0.000000000000000E+00 beta (00001172)=0.133981757448732E+02 gamma(00001172)=0.133981757448732E+02 lr_calc_dens: Charge drift due to real space implementation = -0.17673E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1172 z1= 1 -.278453292271613E-03 0.000000000000000E+00 z1= 2 0.542422261947673E-04 0.000000000000000E+00 z1= 3 -.407768578243370E-02 0.000000000000000E+00 alpha(00001172)=0.000000000000000E+00 beta (00001173)=0.131585602650710E+02 gamma(00001173)=0.131585602650710E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.61347E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1173 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001173)=0.000000000000000E+00 beta (00001174)=0.133033089599580E+02 gamma(00001174)=0.133033089599580E+02 lr_calc_dens: Charge drift due to real space implementation = -0.28445E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1174 z1= 1 0.265066410799382E-03 0.000000000000000E+00 z1= 2 -.447563971544083E-04 0.000000000000000E+00 z1= 3 0.370111608409189E-02 0.000000000000000E+00 alpha(00001174)=0.000000000000000E+00 beta (00001175)=0.131988262230668E+02 gamma(00001175)=0.131988262230668E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.32198E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1175 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001175)=0.000000000000000E+00 beta (00001176)=0.133856678676264E+02 gamma(00001176)=0.133856678676264E+02 lr_calc_dens: Charge drift due to real space implementation = 0.26562E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1176 z1= 1 -.250324507521736E-03 0.000000000000000E+00 z1= 2 0.387855169746015E-04 0.000000000000000E+00 z1= 3 -.335260486160734E-02 0.000000000000000E+00 alpha(00001176)=0.000000000000000E+00 beta (00001177)=0.131353425883795E+02 gamma(00001177)=0.131353425883795E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.98566E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1177 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001177)=0.000000000000000E+00 beta (00001178)=0.133435426527536E+02 gamma(00001178)=0.133435426527536E+02 lr_calc_dens: Charge drift due to real space implementation = 0.96964E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1178 z1= 1 0.234434306010164E-03 0.000000000000000E+00 z1= 2 -.310578165209144E-04 0.000000000000000E+00 z1= 3 0.305831423458819E-02 0.000000000000000E+00 alpha(00001178)=0.000000000000000E+00 beta (00001179)=0.131586997926565E+02 gamma(00001179)=0.131586997926565E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.33089E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1179 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001179)=0.000000000000000E+00 beta (00001180)=0.132551867621705E+02 gamma(00001180)=0.132551867621705E+02 lr_calc_dens: Charge drift due to real space implementation = -0.22324E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1180 z1= 1 -.220224291240420E-03 0.000000000000000E+00 z1= 2 0.278057322064124E-04 0.000000000000000E+00 z1= 3 -.272659257000801E-02 0.000000000000000E+00 alpha(00001180)=0.000000000000000E+00 beta (00001181)=0.131495263243026E+02 gamma(00001181)=0.131495263243026E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.76936E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1181 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001181)=0.000000000000000E+00 beta (00001182)=0.133892163656950E+02 gamma(00001182)=0.133892163656950E+02 lr_calc_dens: Charge drift due to real space implementation = -0.16464E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1182 z1= 1 0.203464308155947E-03 0.000000000000000E+00 z1= 2 -.200549571610156E-04 0.000000000000000E+00 z1= 3 0.229765637197987E-02 0.000000000000000E+00 alpha(00001182)=0.000000000000000E+00 beta (00001183)=0.130516486786460E+02 gamma(00001183)=0.130516486786460E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.79058E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1183 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001183)=0.000000000000000E+00 beta (00001184)=0.134903237998251E+02 gamma(00001184)=0.134903237998251E+02 lr_calc_dens: Charge drift due to real space implementation = 0.40897E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1184 z1= 1 -.183872629043895E-03 0.000000000000000E+00 z1= 2 0.162906238069405E-04 0.000000000000000E+00 z1= 3 -.184883987991278E-02 0.000000000000000E+00 alpha(00001184)=0.000000000000000E+00 beta (00001185)=0.129794551584016E+02 gamma(00001185)=0.129794551584016E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.68348E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1185 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001185)=0.000000000000000E+00 beta (00001186)=0.134640767899065E+02 gamma(00001186)=0.134640767899065E+02 lr_calc_dens: Charge drift due to real space implementation = -0.54492E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1186 z1= 1 0.163634428870013E-03 0.000000000000000E+00 z1= 2 -.701575548294094E-05 0.000000000000000E+00 z1= 3 0.138690267204522E-02 0.000000000000000E+00 alpha(00001186)=0.000000000000000E+00 beta (00001187)=0.132148600278734E+02 gamma(00001187)=0.132148600278734E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.40165E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1187 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001187)=0.000000000000000E+00 beta (00001188)=0.134312688064962E+02 gamma(00001188)=0.134312688064962E+02 lr_calc_dens: Charge drift due to real space implementation = 0.44047E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1188 z1= 1 -.146693206323234E-03 0.000000000000000E+00 z1= 2 0.464099423944792E-05 0.000000000000000E+00 z1= 3 -.102063368975103E-02 0.000000000000000E+00 alpha(00001188)=0.000000000000000E+00 beta (00001189)=0.131456163160764E+02 gamma(00001189)=0.131456163160764E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.16564E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1189 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001189)=0.000000000000000E+00 beta (00001190)=0.134154378016707E+02 gamma(00001190)=0.134154378016707E+02 lr_calc_dens: Charge drift due to real space implementation = -0.38303E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1190 z1= 1 0.128704339569947E-03 0.000000000000000E+00 z1= 2 0.479557241776091E-05 0.000000000000000E+00 z1= 3 0.728818146464562E-03 0.000000000000000E+00 alpha(00001190)=0.000000000000000E+00 beta (00001191)=0.131685364052791E+02 gamma(00001191)=0.131685364052791E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.51539E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1191 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001191)=0.000000000000000E+00 beta (00001192)=0.132842463164286E+02 gamma(00001192)=0.132842463164286E+02 lr_calc_dens: Charge drift due to real space implementation = 0.19898E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1192 z1= 1 -.112203460016920E-03 0.000000000000000E+00 z1= 2 -.746989640876272E-05 0.000000000000000E+00 z1= 3 -.497063701729927E-03 0.000000000000000E+00 alpha(00001192)=0.000000000000000E+00 beta (00001193)=0.131624710939426E+02 gamma(00001193)=0.131624710939426E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.67263E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1193 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001193)=0.000000000000000E+00 beta (00001194)=0.133015948534487E+02 gamma(00001194)=0.133015948534487E+02 lr_calc_dens: Charge drift due to real space implementation = -0.57148E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1194 z1= 1 0.957049687747482E-04 0.000000000000000E+00 z1= 2 0.167342009594375E-04 0.000000000000000E+00 z1= 3 0.333349766952448E-03 0.000000000000000E+00 alpha(00001194)=0.000000000000000E+00 beta (00001195)=0.131176725117322E+02 gamma(00001195)=0.131176725117322E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.39906E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1195 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001195)=0.000000000000000E+00 beta (00001196)=0.133563086914423E+02 gamma(00001196)=0.133563086914423E+02 lr_calc_dens: Charge drift due to real space implementation = 0.60683E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1196 z1= 1 -.796273237771792E-04 0.000000000000000E+00 z1= 2 -.186217053906833E-04 0.000000000000000E+00 z1= 3 -.172960754653526E-03 0.000000000000000E+00 alpha(00001196)=0.000000000000000E+00 beta (00001197)=0.130722163431353E+02 gamma(00001197)=0.130722163431353E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.23134E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1197 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001197)=0.000000000000000E+00 beta (00001198)=0.134131417185953E+02 gamma(00001198)=0.134131417185953E+02 lr_calc_dens: Charge drift due to real space implementation = -0.53203E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1198 z1= 1 0.636971845581636E-04 0.000000000000000E+00 z1= 2 0.276967190578348E-04 0.000000000000000E+00 z1= 3 0.695182511950610E-04 0.000000000000000E+00 alpha(00001198)=0.000000000000000E+00 beta (00001199)=0.131073503393960E+02 gamma(00001199)=0.131073503393960E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.22702E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1199 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001199)=0.000000000000000E+00 beta (00001200)=0.133712077079333E+02 gamma(00001200)=0.133712077079333E+02 lr_calc_dens: Charge drift due to real space implementation = 0.60238E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1200 z1= 1 -.483366358245627E-04 0.000000000000000E+00 z1= 2 -.289668911321057E-04 0.000000000000000E+00 z1= 3 0.376127687464617E-06 0.000000000000000E+00 alpha(00001200)=0.000000000000000E+00 beta (00001201)=0.131045074594707E+02 gamma(00001201)=0.131045074594707E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.79718E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1201 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001201)=0.000000000000000E+00 beta (00001202)=0.133497069204434E+02 gamma(00001202)=0.133497069204434E+02 lr_calc_dens: Charge drift due to real space implementation = -0.52926E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1202 z1= 1 0.332060824488091E-04 0.000000000000000E+00 z1= 2 0.376637324393889E-04 0.000000000000000E+00 z1= 3 -.452636779381919E-05 0.000000000000000E+00 alpha(00001202)=0.000000000000000E+00 beta (00001203)=0.131634793230813E+02 gamma(00001203)=0.131634793230813E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12731E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1203 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001203)=0.000000000000000E+00 beta (00001204)=0.135015881878797E+02 gamma(00001204)=0.135015881878797E+02 lr_calc_dens: Charge drift due to real space implementation = 0.35619E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1204 z1= 1 -.174184885929265E-04 0.000000000000000E+00 z1= 2 -.374450478586950E-04 0.000000000000000E+00 z1= 3 -.620173121216429E-04 0.000000000000000E+00 alpha(00001204)=0.000000000000000E+00 beta (00001205)=0.130827020343168E+02 gamma(00001205)=0.130827020343168E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.33077E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1205 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001205)=0.000000000000000E+00 beta (00001206)=0.135500624590521E+02 gamma(00001206)=0.135500624590521E+02 lr_calc_dens: Charge drift due to real space implementation = -0.19313E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1206 z1= 1 0.153067178788359E-05 0.000000000000000E+00 z1= 2 0.464067426722923E-04 0.000000000000000E+00 z1= 3 0.294828557715603E-04 0.000000000000000E+00 alpha(00001206)=0.000000000000000E+00 beta (00001207)=0.130142829542288E+02 gamma(00001207)=0.130142829542288E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.26070E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1207 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001207)=0.000000000000000E+00 beta (00001208)=0.135133173448954E+02 gamma(00001208)=0.135133173448954E+02 lr_calc_dens: Charge drift due to real space implementation = 0.27056E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1208 z1= 1 0.148010827158065E-04 0.000000000000000E+00 z1= 2 -.471117917632876E-04 0.000000000000000E+00 z1= 3 0.101121457755548E-03 0.000000000000000E+00 alpha(00001208)=0.000000000000000E+00 beta (00001209)=0.130483795162888E+02 gamma(00001209)=0.130483795162888E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.36194E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1209 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001209)=0.000000000000000E+00 beta (00001210)=0.134516407472838E+02 gamma(00001210)=0.134516407472838E+02 lr_calc_dens: Charge drift due to real space implementation = -0.53094E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1210 z1= 1 -.301842698367423E-04 0.000000000000000E+00 z1= 2 0.579403513135610E-04 0.000000000000000E+00 z1= 3 -.233143958402104E-03 0.000000000000000E+00 alpha(00001210)=0.000000000000000E+00 beta (00001211)=0.130206611667876E+02 gamma(00001211)=0.130206611667876E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.16135E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1211 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001211)=0.000000000000000E+00 beta (00001212)=0.134140754590899E+02 gamma(00001212)=0.134140754590899E+02 lr_calc_dens: Charge drift due to real space implementation = 0.35210E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1212 z1= 1 0.461436142396403E-04 0.000000000000000E+00 z1= 2 -.609103476784979E-04 0.000000000000000E+00 z1= 3 0.382153202414583E-03 0.000000000000000E+00 alpha(00001212)=0.000000000000000E+00 beta (00001213)=0.131971680723478E+02 gamma(00001213)=0.131971680723478E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.23511E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1213 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001213)=0.000000000000000E+00 beta (00001214)=0.134638746911024E+02 gamma(00001214)=0.134638746911024E+02 lr_calc_dens: Charge drift due to real space implementation = 0.54032E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1214 z1= 1 -.607604091268036E-04 0.000000000000000E+00 z1= 2 0.719286569961126E-04 0.000000000000000E+00 z1= 3 -.668642469842586E-03 0.000000000000000E+00 alpha(00001214)=0.000000000000000E+00 beta (00001215)=0.130435957013864E+02 gamma(00001215)=0.130435957013864E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13552E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1215 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001215)=0.000000000000000E+00 beta (00001216)=0.134681551526638E+02 gamma(00001216)=0.134681551526638E+02 lr_calc_dens: Charge drift due to real space implementation = 0.41915E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1216 z1= 1 0.761753559982217E-04 0.000000000000000E+00 z1= 2 -.753896386858806E-04 0.000000000000000E+00 z1= 3 0.110861353694712E-02 0.000000000000000E+00 alpha(00001216)=0.000000000000000E+00 beta (00001217)=0.131367232511349E+02 gamma(00001217)=0.131367232511349E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.50272E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1217 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001217)=0.000000000000000E+00 beta (00001218)=0.134659949616900E+02 gamma(00001218)=0.134659949616900E+02 lr_calc_dens: Charge drift due to real space implementation = -0.57736E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1218 z1= 1 -.911556244797794E-04 0.000000000000000E+00 z1= 2 0.847773434221235E-04 0.000000000000000E+00 z1= 3 -.151010262623960E-02 0.000000000000000E+00 alpha(00001218)=0.000000000000000E+00 beta (00001219)=0.129901426660477E+02 gamma(00001219)=0.129901426660477E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.33351E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1219 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001219)=0.000000000000000E+00 beta (00001220)=0.135242531575146E+02 gamma(00001220)=0.135242531575146E+02 lr_calc_dens: Charge drift due to real space implementation = 0.83882E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1220 z1= 1 0.106575691584817E-03 0.000000000000000E+00 z1= 2 -.858439292466817E-04 0.000000000000000E+00 z1= 3 0.154948144825341E-02 0.000000000000000E+00 alpha(00001220)=0.000000000000000E+00 beta (00001221)=0.130435665511808E+02 gamma(00001221)=0.130435665511808E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.15638E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1221 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001221)=0.000000000000000E+00 beta (00001222)=0.135941314215484E+02 gamma(00001222)=0.135941314215484E+02 lr_calc_dens: Charge drift due to real space implementation = -0.45203E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1222 z1= 1 -.120326282496142E-03 0.000000000000000E+00 z1= 2 0.904358330284464E-04 0.000000000000000E+00 z1= 3 -.124697214372260E-02 0.000000000000000E+00 alpha(00001222)=0.000000000000000E+00 beta (00001223)=0.130041523598861E+02 gamma(00001223)=0.130041523598861E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.24565E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1223 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001223)=0.000000000000000E+00 beta (00001224)=0.134283858682333E+02 gamma(00001224)=0.134283858682333E+02 lr_calc_dens: Charge drift due to real space implementation = 0.32229E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1224 z1= 1 0.137410890777758E-03 0.000000000000000E+00 z1= 2 -.919221080327992E-04 0.000000000000000E+00 z1= 3 0.882105298402779E-03 0.000000000000000E+00 alpha(00001224)=0.000000000000000E+00 beta (00001225)=0.131090029711156E+02 gamma(00001225)=0.131090029711156E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.74120E-10 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1225 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001225)=0.000000000000000E+00 beta (00001226)=0.132912891585418E+02 gamma(00001226)=0.132912891585418E+02 lr_calc_dens: Charge drift due to real space implementation = 0.15643E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1226 z1= 1 -.155410016639474E-03 0.000000000000000E+00 z1= 2 0.976281017433054E-04 0.000000000000000E+00 z1= 3 -.703661076515413E-03 0.000000000000000E+00 alpha(00001226)=0.000000000000000E+00 beta (00001227)=0.131184403852004E+02 gamma(00001227)=0.131184403852004E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.38086E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1227 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001227)=0.000000000000000E+00 beta (00001228)=0.134639811988791E+02 gamma(00001228)=0.134639811988791E+02 lr_calc_dens: Charge drift due to real space implementation = -0.31121E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1228 z1= 1 0.171969949598762E-03 0.000000000000000E+00 z1= 2 -.100503708068076E-03 0.000000000000000E+00 z1= 3 0.767633885825601E-03 0.000000000000000E+00 alpha(00001228)=0.000000000000000E+00 beta (00001229)=0.130441530827045E+02 gamma(00001229)=0.130441530827045E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.64345E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1229 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001229)=0.000000000000000E+00 beta (00001230)=0.135022614633113E+02 gamma(00001230)=0.135022614633113E+02 lr_calc_dens: Charge drift due to real space implementation = -0.30722E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1230 z1= 1 -.184175657964785E-03 0.000000000000000E+00 z1= 2 0.102541027861811E-03 0.000000000000000E+00 z1= 3 -.980484481818707E-03 0.000000000000000E+00 alpha(00001230)=0.000000000000000E+00 beta (00001231)=0.129926103856751E+02 gamma(00001231)=0.129926103856751E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.53857E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1231 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001231)=0.000000000000000E+00 beta (00001232)=0.134452624037233E+02 gamma(00001232)=0.134452624037233E+02 lr_calc_dens: Charge drift due to real space implementation = 0.50054E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1232 z1= 1 0.198107123009165E-03 0.000000000000000E+00 z1= 2 -.105377810322244E-03 0.000000000000000E+00 z1= 3 0.124741157109065E-02 0.000000000000000E+00 alpha(00001232)=0.000000000000000E+00 beta (00001233)=0.130547820947340E+02 gamma(00001233)=0.130547820947340E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.28756E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1233 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001233)=0.000000000000000E+00 beta (00001234)=0.134515856186093E+02 gamma(00001234)=0.134515856186093E+02 lr_calc_dens: Charge drift due to real space implementation = -0.50488E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1234 z1= 1 -.211252795123020E-03 0.000000000000000E+00 z1= 2 0.106936448577247E-03 0.000000000000000E+00 z1= 3 -.147737231346746E-02 0.000000000000000E+00 alpha(00001234)=0.000000000000000E+00 beta (00001235)=0.131270170040379E+02 gamma(00001235)=0.131270170040379E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.69891E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1235 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001235)=0.000000000000000E+00 beta (00001236)=0.134051048776731E+02 gamma(00001236)=0.134051048776731E+02 lr_calc_dens: Charge drift due to real space implementation = 0.40731E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1236 z1= 1 0.228784482075681E-03 0.000000000000000E+00 z1= 2 -.111528361785011E-03 0.000000000000000E+00 z1= 3 0.172331078647734E-02 0.000000000000000E+00 alpha(00001236)=0.000000000000000E+00 beta (00001237)=0.131405685704422E+02 gamma(00001237)=0.131405685704422E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.54556E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1237 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001237)=0.000000000000000E+00 beta (00001238)=0.133643662547455E+02 gamma(00001238)=0.133643662547455E+02 lr_calc_dens: Charge drift due to real space implementation = -0.18224E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1238 z1= 1 -.245678964905406E-03 0.000000000000000E+00 z1= 2 0.112464945221533E-03 0.000000000000000E+00 z1= 3 -.196735760759394E-02 0.000000000000000E+00 alpha(00001238)=0.000000000000000E+00 beta (00001239)=0.131033929409807E+02 gamma(00001239)=0.131033929409807E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.15756E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1239 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001239)=0.000000000000000E+00 beta (00001240)=0.134435907646297E+02 gamma(00001240)=0.134435907646297E+02 lr_calc_dens: Charge drift due to real space implementation = 0.19233E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1240 z1= 1 0.262919005261339E-03 0.000000000000000E+00 z1= 2 -.117692456825663E-03 0.000000000000000E+00 z1= 3 0.208430051766833E-02 0.000000000000000E+00 alpha(00001240)=0.000000000000000E+00 beta (00001241)=0.130738079213552E+02 gamma(00001241)=0.130738079213552E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.37793E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1241 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001241)=0.000000000000000E+00 beta (00001242)=0.134607667913436E+02 gamma(00001242)=0.134607667913436E+02 lr_calc_dens: Charge drift due to real space implementation = -0.38424E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1242 z1= 1 -.276102705049373E-03 0.000000000000000E+00 z1= 2 0.118662700614822E-03 0.000000000000000E+00 z1= 3 -.205371810856715E-02 0.000000000000000E+00 alpha(00001242)=0.000000000000000E+00 beta (00001243)=0.128972673965123E+02 gamma(00001243)=0.128972673965123E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.40246E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1243 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001243)=0.000000000000000E+00 beta (00001244)=0.133125633005587E+02 gamma(00001244)=0.133125633005587E+02 lr_calc_dens: Charge drift due to real space implementation = 0.46651E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1244 z1= 1 0.291439668290271E-03 0.000000000000000E+00 z1= 2 -.125914548591073E-03 0.000000000000000E+00 z1= 3 0.185519103569953E-02 0.000000000000000E+00 alpha(00001244)=0.000000000000000E+00 beta (00001245)=0.130639516927328E+02 gamma(00001245)=0.130639516927328E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.39882E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1245 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001245)=0.000000000000000E+00 beta (00001246)=0.134261151941641E+02 gamma(00001246)=0.134261151941641E+02 lr_calc_dens: Charge drift due to real space implementation = -0.62653E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1246 z1= 1 -.304513660476981E-03 0.000000000000000E+00 z1= 2 0.127129881379693E-03 0.000000000000000E+00 z1= 3 -.148705461590370E-02 0.000000000000000E+00 alpha(00001246)=0.000000000000000E+00 beta (00001247)=0.130309259796271E+02 gamma(00001247)=0.130309259796271E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.16957E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1247 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001247)=0.000000000000000E+00 beta (00001248)=0.134447356003827E+02 gamma(00001248)=0.134447356003827E+02 lr_calc_dens: Charge drift due to real space implementation = 0.63148E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1248 z1= 1 0.319234602038847E-03 0.000000000000000E+00 z1= 2 -.135002821223022E-03 0.000000000000000E+00 z1= 3 0.944397700791135E-03 0.000000000000000E+00 alpha(00001248)=0.000000000000000E+00 beta (00001249)=0.130876039085185E+02 gamma(00001249)=0.130876039085185E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.18675E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1249 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001249)=0.000000000000000E+00 beta (00001250)=0.133990767496447E+02 gamma(00001250)=0.133990767496447E+02 lr_calc_dens: Charge drift due to real space implementation = -0.32724E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1250 z1= 1 -.332774528042083E-03 0.000000000000000E+00 z1= 2 0.133794964373215E-03 0.000000000000000E+00 z1= 3 -.539758902842658E-03 0.000000000000000E+00 alpha(00001250)=0.000000000000000E+00 beta (00001251)=0.130684871305266E+02 gamma(00001251)=0.130684871305266E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.29237E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1251 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001251)=0.000000000000000E+00 beta (00001252)=0.134086405583965E+02 gamma(00001252)=0.134086405583965E+02 lr_calc_dens: Charge drift due to real space implementation = 0.15045E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1252 z1= 1 0.348638718940154E-03 0.000000000000000E+00 z1= 2 -.142658388956812E-03 0.000000000000000E+00 z1= 3 0.459821425719795E-03 0.000000000000000E+00 alpha(00001252)=0.000000000000000E+00 beta (00001253)=0.130415534118739E+02 gamma(00001253)=0.130415534118739E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.22377E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1253 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001253)=0.000000000000000E+00 beta (00001254)=0.133759490857160E+02 gamma(00001254)=0.133759490857160E+02 lr_calc_dens: Charge drift due to real space implementation = 0.32651E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1254 z1= 1 -.360683481004213E-03 0.000000000000000E+00 z1= 2 0.140248115809715E-03 0.000000000000000E+00 z1= 3 -.680305251285909E-03 0.000000000000000E+00 alpha(00001254)=0.000000000000000E+00 beta (00001255)=0.130283097965789E+02 gamma(00001255)=0.130283097965789E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.30552E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1255 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001255)=0.000000000000000E+00 beta (00001256)=0.134427666672110E+02 gamma(00001256)=0.134427666672110E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10091E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1256 z1= 1 0.374501772105825E-03 0.000000000000000E+00 z1= 2 -.149200478396850E-03 0.000000000000000E+00 z1= 3 0.122752517805290E-02 0.000000000000000E+00 alpha(00001256)=0.000000000000000E+00 beta (00001257)=0.130677678640104E+02 gamma(00001257)=0.130677678640104E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.73657E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1257 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001257)=0.000000000000000E+00 beta (00001258)=0.134314085258322E+02 gamma(00001258)=0.134314085258322E+02 lr_calc_dens: Charge drift due to real space implementation = -0.55595E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1258 z1= 1 -.385059892433393E-03 0.000000000000000E+00 z1= 2 0.144536586263568E-03 0.000000000000000E+00 z1= 3 -.181323900091206E-02 0.000000000000000E+00 alpha(00001258)=0.000000000000000E+00 beta (00001259)=0.131352295563277E+02 gamma(00001259)=0.131352295563277E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.65103E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1259 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001259)=0.000000000000000E+00 beta (00001260)=0.134166695936924E+02 gamma(00001260)=0.134166695936924E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11209E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1260 z1= 1 0.402093654544008E-03 0.000000000000000E+00 z1= 2 -.155542869116950E-03 0.000000000000000E+00 z1= 3 0.208566639023091E-02 0.000000000000000E+00 alpha(00001260)=0.000000000000000E+00 beta (00001261)=0.130348162542187E+02 gamma(00001261)=0.130348162542187E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.18406E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1261 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001261)=0.000000000000000E+00 beta (00001262)=0.134424714934724E+02 gamma(00001262)=0.134424714934724E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10004E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1262 z1= 1 -.409888775280684E-03 0.000000000000000E+00 z1= 2 0.148810775671712E-03 0.000000000000000E+00 z1= 3 -.193193750309597E-02 0.000000000000000E+00 alpha(00001262)=0.000000000000000E+00 beta (00001263)=0.131321489299450E+02 gamma(00001263)=0.131321489299450E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.45389E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1263 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001263)=0.000000000000000E+00 beta (00001264)=0.134424182105904E+02 gamma(00001264)=0.134424182105904E+02 lr_calc_dens: Charge drift due to real space implementation = 0.48198E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1264 z1= 1 0.426127834168809E-03 0.000000000000000E+00 z1= 2 -.160820016448321E-03 0.000000000000000E+00 z1= 3 0.148802493334254E-02 0.000000000000000E+00 alpha(00001264)=0.000000000000000E+00 beta (00001265)=0.129753252711126E+02 gamma(00001265)=0.129753252711126E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.57075E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1265 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001265)=0.000000000000000E+00 beta (00001266)=0.134993697400424E+02 gamma(00001266)=0.134993697400424E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12666E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1266 z1= 1 -.429405601355560E-03 0.000000000000000E+00 z1= 2 0.151963058790443E-03 0.000000000000000E+00 z1= 3 -.996094991199507E-03 0.000000000000000E+00 alpha(00001266)=0.000000000000000E+00 beta (00001267)=0.129965915982868E+02 gamma(00001267)=0.129965915982868E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.15732E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1267 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001267)=0.000000000000000E+00 beta (00001268)=0.135990300755741E+02 gamma(00001268)=0.135990300755741E+02 lr_calc_dens: Charge drift due to real space implementation = -0.20904E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1268 z1= 1 0.435259029614544E-03 0.000000000000000E+00 z1= 2 -.162207998669568E-03 0.000000000000000E+00 z1= 3 0.685725959743897E-03 0.000000000000000E+00 alpha(00001268)=0.000000000000000E+00 beta (00001269)=0.131259658778515E+02 gamma(00001269)=0.131259658778515E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.23438E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1269 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001269)=0.000000000000000E+00 beta (00001270)=0.135160263413252E+02 gamma(00001270)=0.135160263413252E+02 lr_calc_dens: Charge drift due to real space implementation = -0.19500E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1270 z1= 1 -.441028684652046E-03 0.000000000000000E+00 z1= 2 0.154648208885711E-03 0.000000000000000E+00 z1= 3 -.545233405499859E-03 0.000000000000000E+00 alpha(00001270)=0.000000000000000E+00 beta (00001271)=0.130015597024274E+02 gamma(00001271)=0.130015597024274E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13297E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1271 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001271)=0.000000000000000E+00 beta (00001272)=0.134094577183811E+02 gamma(00001272)=0.134094577183811E+02 lr_calc_dens: Charge drift due to real space implementation = 0.50258E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1272 z1= 1 0.451860025730144E-03 0.000000000000000E+00 z1= 2 -.167340442511653E-03 0.000000000000000E+00 z1= 3 0.480721585023734E-03 0.000000000000000E+00 alpha(00001272)=0.000000000000000E+00 beta (00001273)=0.131700548845012E+02 gamma(00001273)=0.131700548845012E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.36288E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1273 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001273)=0.000000000000000E+00 beta (00001274)=0.133298367502482E+02 gamma(00001274)=0.133298367502482E+02 lr_calc_dens: Charge drift due to real space implementation = -0.24350E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1274 z1= 1 -.465261493452608E-03 0.000000000000000E+00 z1= 2 0.162833814613281E-03 0.000000000000000E+00 z1= 3 -.372556716711343E-03 0.000000000000000E+00 alpha(00001274)=0.000000000000000E+00 beta (00001275)=0.131606951727709E+02 gamma(00001275)=0.131606951727709E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.46941E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1275 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001275)=0.000000000000000E+00 beta (00001276)=0.134456654551235E+02 gamma(00001276)=0.134456654551235E+02 lr_calc_dens: Charge drift due to real space implementation = -0.80605E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1276 z1= 1 0.480739872060255E-03 0.000000000000000E+00 z1= 2 -.177637047371971E-03 0.000000000000000E+00 z1= 3 0.304273847686838E-03 0.000000000000000E+00 alpha(00001276)=0.000000000000000E+00 beta (00001277)=0.130619662426939E+02 gamma(00001277)=0.130619662426939E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13248E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1277 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001277)=0.000000000000000E+00 beta (00001278)=0.134933356182837E+02 gamma(00001278)=0.134933356182837E+02 lr_calc_dens: Charge drift due to real space implementation = -0.88956E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1278 z1= 1 -.486685626746614E-03 0.000000000000000E+00 z1= 2 0.169763569723513E-03 0.000000000000000E+00 z1= 3 -.398028927017440E-03 0.000000000000000E+00 alpha(00001278)=0.000000000000000E+00 beta (00001279)=0.129973721086922E+02 gamma(00001279)=0.129973721086922E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.32742E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1279 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001279)=0.000000000000000E+00 beta (00001280)=0.134408723407091E+02 gamma(00001280)=0.134408723407091E+02 lr_calc_dens: Charge drift due to real space implementation = 0.33510E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1280 z1= 1 0.497772479176883E-03 0.000000000000000E+00 z1= 2 -.180769383611768E-03 0.000000000000000E+00 z1= 3 0.475448083276070E-03 0.000000000000000E+00 alpha(00001280)=0.000000000000000E+00 beta (00001281)=0.130295467057557E+02 gamma(00001281)=0.130295467057557E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.62191E-10 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1281 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001281)=0.000000000000000E+00 beta (00001282)=0.134586082394296E+02 gamma(00001282)=0.134586082394296E+02 lr_calc_dens: Charge drift due to real space implementation = -0.46573E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1282 z1= 1 -.504255937708720E-03 0.000000000000000E+00 z1= 2 0.172643943984196E-03 0.000000000000000E+00 z1= 3 -.339194594239660E-03 0.000000000000000E+00 alpha(00001282)=0.000000000000000E+00 beta (00001283)=0.130541607218161E+02 gamma(00001283)=0.130541607218161E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.96828E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1283 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001283)=0.000000000000000E+00 beta (00001284)=0.133933160881133E+02 gamma(00001284)=0.133933160881133E+02 lr_calc_dens: Charge drift due to real space implementation = 0.55944E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1284 z1= 1 0.518427348646404E-03 0.000000000000000E+00 z1= 2 -.184639816401102E-03 0.000000000000000E+00 z1= 3 -.816046785223155E-04 0.000000000000000E+00 alpha(00001284)=0.000000000000000E+00 beta (00001285)=0.130203422203362E+02 gamma(00001285)=0.130203422203362E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.49487E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1285 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001285)=0.000000000000000E+00 beta (00001286)=0.134590482075009E+02 gamma(00001286)=0.134590482075009E+02 lr_calc_dens: Charge drift due to real space implementation = -0.23841E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1286 z1= 1 -.524597817530460E-03 0.000000000000000E+00 z1= 2 0.176163873942531E-03 0.000000000000000E+00 z1= 3 0.598983796909487E-03 0.000000000000000E+00 alpha(00001286)=0.000000000000000E+00 beta (00001287)=0.130810305823435E+02 gamma(00001287)=0.130810305823435E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.66881E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1287 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001287)=0.000000000000000E+00 beta (00001288)=0.134069146178197E+02 gamma(00001288)=0.134069146178197E+02 lr_calc_dens: Charge drift due to real space implementation = -0.23841E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1288 z1= 1 0.539265681354059E-03 0.000000000000000E+00 z1= 2 -.189578104198401E-03 0.000000000000000E+00 z1= 3 -.100235960369799E-02 0.000000000000000E+00 alpha(00001288)=0.000000000000000E+00 beta (00001289)=0.130938800183710E+02 gamma(00001289)=0.130938800183710E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.41235E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1289 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001289)=0.000000000000000E+00 beta (00001290)=0.135051749496473E+02 gamma(00001290)=0.135051749496473E+02 lr_calc_dens: Charge drift due to real space implementation = 0.37747E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1290 z1= 1 -.544899390765560E-03 0.000000000000000E+00 z1= 2 0.182300014729341E-03 0.000000000000000E+00 z1= 3 0.110777084864692E-02 0.000000000000000E+00 alpha(00001290)=0.000000000000000E+00 beta (00001291)=0.130268021464636E+02 gamma(00001291)=0.130268021464636E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.32260E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1291 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001291)=0.000000000000000E+00 beta (00001292)=0.133863262108703E+02 gamma(00001292)=0.133863262108703E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12785E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1292 z1= 1 0.554862555439333E-03 0.000000000000000E+00 z1= 2 -.195593769556027E-03 0.000000000000000E+00 z1= 3 -.809915650437300E-03 0.000000000000000E+00 alpha(00001292)=0.000000000000000E+00 beta (00001293)=0.129782430503418E+02 gamma(00001293)=0.129782430503418E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.16453E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1293 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001293)=0.000000000000000E+00 beta (00001294)=0.134910597655820E+02 gamma(00001294)=0.134910597655820E+02 lr_calc_dens: Charge drift due to real space implementation = -0.43146E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1294 z1= 1 -.553806521072373E-03 0.000000000000000E+00 z1= 2 0.185093818448693E-03 0.000000000000000E+00 z1= 3 0.418060439085652E-03 0.000000000000000E+00 alpha(00001294)=0.000000000000000E+00 beta (00001295)=0.129621791356874E+02 gamma(00001295)=0.129621791356874E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.17128E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1295 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001295)=0.000000000000000E+00 beta (00001296)=0.136550196897034E+02 gamma(00001296)=0.136550196897034E+02 lr_calc_dens: Charge drift due to real space implementation = 0.56665E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1296 z1= 1 0.549634937407360E-03 0.000000000000000E+00 z1= 2 -.193170454597520E-03 0.000000000000000E+00 z1= 3 -.227798331492488E-03 0.000000000000000E+00 alpha(00001296)=0.000000000000000E+00 beta (00001297)=0.129996724973282E+02 gamma(00001297)=0.129996724973282E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.51000E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1297 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001297)=0.000000000000000E+00 beta (00001298)=0.134608397445220E+02 gamma(00001298)=0.134608397445220E+02 lr_calc_dens: Charge drift due to real space implementation = -0.44680E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1298 z1= 1 -.552879414993174E-03 0.000000000000000E+00 z1= 2 0.182834240995627E-03 0.000000000000000E+00 z1= 3 0.198061459788240E-03 0.000000000000000E+00 alpha(00001298)=0.000000000000000E+00 beta (00001299)=0.130968102483398E+02 gamma(00001299)=0.130968102483398E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.66400E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1299 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001299)=0.000000000000000E+00 beta (00001300)=0.135095135687510E+02 gamma(00001300)=0.135095135687510E+02 lr_calc_dens: Charge drift due to real space implementation = 0.16605E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1300 z1= 1 0.561684984479335E-03 0.000000000000000E+00 z1= 2 -.195551293703635E-03 0.000000000000000E+00 z1= 3 -.170261084970325E-03 0.000000000000000E+00 alpha(00001300)=0.000000000000000E+00 beta (00001301)=0.130677852975355E+02 gamma(00001301)=0.130677852975355E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.65984E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1301 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001301)=0.000000000000000E+00 beta (00001302)=0.134929476648578E+02 gamma(00001302)=0.134929476648578E+02 lr_calc_dens: Charge drift due to real space implementation = 0.68378E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1302 z1= 1 -.567744621082714E-03 0.000000000000000E+00 z1= 2 0.187307868378274E-03 0.000000000000000E+00 z1= 3 0.101957464124521E-03 0.000000000000000E+00 alpha(00001302)=0.000000000000000E+00 beta (00001303)=0.130214238552009E+02 gamma(00001303)=0.130214238552009E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.52742E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1303 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001303)=0.000000000000000E+00 beta (00001304)=0.134430093601750E+02 gamma(00001304)=0.134430093601750E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10919E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1304 z1= 1 0.577869526559791E-03 0.000000000000000E+00 z1= 2 -.198970595114001E-03 0.000000000000000E+00 z1= 3 -.119422998665226E-03 0.000000000000000E+00 alpha(00001304)=0.000000000000000E+00 beta (00001305)=0.130680543606539E+02 gamma(00001305)=0.130680543606539E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.55231E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1305 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001305)=0.000000000000000E+00 beta (00001306)=0.135003810968950E+02 gamma(00001306)=0.135003810968950E+02 lr_calc_dens: Charge drift due to real space implementation = 0.16818E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1306 z1= 1 -.583798312038618E-03 0.000000000000000E+00 z1= 2 0.190708200389944E-03 0.000000000000000E+00 z1= 3 0.133432660676280E-03 0.000000000000000E+00 alpha(00001306)=0.000000000000000E+00 beta (00001307)=0.130785262212713E+02 gamma(00001307)=0.130785262212713E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.48986E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1307 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001307)=0.000000000000000E+00 beta (00001308)=0.134855981110770E+02 gamma(00001308)=0.134855981110770E+02 lr_calc_dens: Charge drift due to real space implementation = -0.16655E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1308 z1= 1 0.593491235776400E-03 0.000000000000000E+00 z1= 2 -.203134536755068E-03 0.000000000000000E+00 z1= 3 -.299555316050464E-04 0.000000000000000E+00 alpha(00001308)=0.000000000000000E+00 beta (00001309)=0.130336079865015E+02 gamma(00001309)=0.130336079865015E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.31323E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1309 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001309)=0.000000000000000E+00 beta (00001310)=0.134163467094050E+02 gamma(00001310)=0.134163467094050E+02 lr_calc_dens: Charge drift due to real space implementation = -0.15851E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1310 z1= 1 -.601008361989530E-03 0.000000000000000E+00 z1= 2 0.197052089780167E-03 0.000000000000000E+00 z1= 3 -.154745784058021E-03 0.000000000000000E+00 alpha(00001310)=0.000000000000000E+00 beta (00001311)=0.130954094452804E+02 gamma(00001311)=0.130954094452804E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.38188E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1311 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001311)=0.000000000000000E+00 beta (00001312)=0.134537179208124E+02 gamma(00001312)=0.134537179208124E+02 lr_calc_dens: Charge drift due to real space implementation = 0.28549E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1312 z1= 1 0.611938210703307E-03 0.000000000000000E+00 z1= 2 -.210499828657234E-03 0.000000000000000E+00 z1= 3 0.246446357358097E-03 0.000000000000000E+00 alpha(00001312)=0.000000000000000E+00 beta (00001313)=0.130607886185204E+02 gamma(00001313)=0.130607886185204E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.49323E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1313 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001313)=0.000000000000000E+00 beta (00001314)=0.134000809366814E+02 gamma(00001314)=0.134000809366814E+02 lr_calc_dens: Charge drift due to real space implementation = -0.35988E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1314 z1= 1 -.619887547579040E-03 0.000000000000000E+00 z1= 2 0.206079051960044E-03 0.000000000000000E+00 z1= 3 -.195316890053767E-03 0.000000000000000E+00 alpha(00001314)=0.000000000000000E+00 beta (00001315)=0.132065791832897E+02 gamma(00001315)=0.132065791832897E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.74683E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1315 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001315)=0.000000000000000E+00 beta (00001316)=0.134503222408025E+02 gamma(00001316)=0.134503222408025E+02 lr_calc_dens: Charge drift due to real space implementation = 0.13589E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1316 z1= 1 0.634853675792345E-03 0.000000000000000E+00 z1= 2 -.220618176768263E-03 0.000000000000000E+00 z1= 3 0.148497273432222E-03 0.000000000000000E+00 alpha(00001316)=0.000000000000000E+00 beta (00001317)=0.131348590202392E+02 gamma(00001317)=0.131348590202392E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.85111E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1317 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001317)=0.000000000000000E+00 beta (00001318)=0.133988915001795E+02 gamma(00001318)=0.133988915001795E+02 lr_calc_dens: Charge drift due to real space implementation = 0.55261E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1318 z1= 1 -.645678840006736E-03 0.000000000000000E+00 z1= 2 0.217613788231900E-03 0.000000000000000E+00 z1= 3 -.125640642875203E-03 0.000000000000000E+00 alpha(00001318)=0.000000000000000E+00 beta (00001319)=0.130100404478885E+02 gamma(00001319)=0.130100404478885E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.86283E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1319 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001319)=0.000000000000000E+00 beta (00001320)=0.134886468078714E+02 gamma(00001320)=0.134886468078714E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12359E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1320 z1= 1 0.648923537431059E-03 0.000000000000000E+00 z1= 2 -.225783866289796E-03 0.000000000000000E+00 z1= 3 0.964512702599542E-04 0.000000000000000E+00 alpha(00001320)=0.000000000000000E+00 beta (00001321)=0.131228267620937E+02 gamma(00001321)=0.131228267620937E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10299E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1321 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001321)=0.000000000000000E+00 beta (00001322)=0.134219383409072E+02 gamma(00001322)=0.134219383409072E+02 lr_calc_dens: Charge drift due to real space implementation = 0.30206E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1322 z1= 1 -.656713250542150E-03 0.000000000000000E+00 z1= 2 0.222148829799232E-03 0.000000000000000E+00 z1= 3 -.361828825431506E-04 0.000000000000000E+00 alpha(00001322)=0.000000000000000E+00 beta (00001323)=0.130988861077617E+02 gamma(00001323)=0.130988861077617E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11376E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1323 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001323)=0.000000000000000E+00 beta (00001324)=0.133930157377870E+02 gamma(00001324)=0.133930157377870E+02 lr_calc_dens: Charge drift due to real space implementation = -0.75612E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1324 z1= 1 0.667456037246154E-03 0.000000000000000E+00 z1= 2 -.232272802633874E-03 0.000000000000000E+00 z1= 3 0.275493300752119E-04 0.000000000000000E+00 alpha(00001324)=0.000000000000000E+00 beta (00001325)=0.130410692938476E+02 gamma(00001325)=0.130410692938476E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.63479E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1325 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001325)=0.000000000000000E+00 beta (00001326)=0.134039651720223E+02 gamma(00001326)=0.134039651720223E+02 lr_calc_dens: Charge drift due to real space implementation = 0.59544E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1326 z1= 1 -.670736107943650E-03 0.000000000000000E+00 z1= 2 0.228327156704976E-03 0.000000000000000E+00 z1= 3 -.250760811839398E-03 0.000000000000000E+00 alpha(00001326)=0.000000000000000E+00 beta (00001327)=0.130067510626945E+02 gamma(00001327)=0.130067510626945E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.16236E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1327 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001327)=0.000000000000000E+00 beta (00001328)=0.135612397190552E+02 gamma(00001328)=0.135612397190552E+02 lr_calc_dens: Charge drift due to real space implementation = 0.63194E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1328 z1= 1 0.667389868994043E-03 0.000000000000000E+00 z1= 2 -.232185852528088E-03 0.000000000000000E+00 z1= 3 0.532631371706924E-03 0.000000000000000E+00 alpha(00001328)=0.000000000000000E+00 beta (00001329)=0.129737005322454E+02 gamma(00001329)=0.129737005322454E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.38357E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1329 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001329)=0.000000000000000E+00 beta (00001330)=0.134307884994509E+02 gamma(00001330)=0.134307884994509E+02 lr_calc_dens: Charge drift due to real space implementation = -0.44618E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1330 z1= 1 -.663999523684729E-03 0.000000000000000E+00 z1= 2 0.226787487689158E-03 0.000000000000000E+00 z1= 3 -.556964204771367E-03 0.000000000000000E+00 alpha(00001330)=0.000000000000000E+00 beta (00001331)=0.129804288416194E+02 gamma(00001331)=0.129804288416194E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.10109E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1331 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001331)=0.000000000000000E+00 beta (00001332)=0.134583330922727E+02 gamma(00001332)=0.134583330922727E+02 lr_calc_dens: Charge drift due to real space implementation = 0.78148E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1332 z1= 1 0.663236306207749E-03 0.000000000000000E+00 z1= 2 -.230153011975203E-03 0.000000000000000E+00 z1= 3 0.335813785346075E-03 0.000000000000000E+00 alpha(00001332)=0.000000000000000E+00 beta (00001333)=0.129824970149522E+02 gamma(00001333)=0.129824970149522E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.13228E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1333 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001333)=0.000000000000000E+00 beta (00001334)=0.134650892008535E+02 gamma(00001334)=0.134650892008535E+02 lr_calc_dens: Charge drift due to real space implementation = 0.63920E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1334 z1= 1 -.657273305304182E-03 0.000000000000000E+00 z1= 2 0.223200336410181E-03 0.000000000000000E+00 z1= 3 -.583664178629116E-05 0.000000000000000E+00 alpha(00001334)=0.000000000000000E+00 beta (00001335)=0.130413060948884E+02 gamma(00001335)=0.130413060948884E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.87891E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1335 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001335)=0.000000000000000E+00 beta (00001336)=0.135070020424415E+02 gamma(00001336)=0.135070020424415E+02 lr_calc_dens: Charge drift due to real space implementation = -0.78472E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1336 z1= 1 0.657572969587355E-03 0.000000000000000E+00 z1= 2 -.227443470720627E-03 0.000000000000000E+00 z1= 3 -.135370708631568E-03 0.000000000000000E+00 alpha(00001336)=0.000000000000000E+00 beta (00001337)=0.131762564275721E+02 gamma(00001337)=0.131762564275721E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.42172E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1337 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001337)=0.000000000000000E+00 beta (00001338)=0.134227583419398E+02 gamma(00001338)=0.134227583419398E+02 lr_calc_dens: Charge drift due to real space implementation = 0.28841E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1338 z1= 1 -.662618668188245E-03 0.000000000000000E+00 z1= 2 0.225753856109489E-03 0.000000000000000E+00 z1= 3 -.881063162344337E-04 0.000000000000000E+00 alpha(00001338)=0.000000000000000E+00 beta (00001339)=0.130520476531368E+02 gamma(00001339)=0.130520476531368E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.62207E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1339 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001339)=0.000000000000000E+00 beta (00001340)=0.134940676247551E+02 gamma(00001340)=0.134940676247551E+02 lr_calc_dens: Charge drift due to real space implementation = -0.17172E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1340 z1= 1 0.664703919855084E-03 0.000000000000000E+00 z1= 2 -.230626417695498E-03 0.000000000000000E+00 z1= 3 0.388789538618414E-03 0.000000000000000E+00 alpha(00001340)=0.000000000000000E+00 beta (00001341)=0.131938737491748E+02 gamma(00001341)=0.131938737491748E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12011E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1341 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001341)=0.000000000000000E+00 beta (00001342)=0.134537213406323E+02 gamma(00001342)=0.134537213406323E+02 lr_calc_dens: Charge drift due to real space implementation = 0.37099E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1342 z1= 1 -.667999837012568E-03 0.000000000000000E+00 z1= 2 0.227330061240974E-03 0.000000000000000E+00 z1= 3 -.471962690892868E-03 0.000000000000000E+00 alpha(00001342)=0.000000000000000E+00 beta (00001343)=0.131260883708235E+02 gamma(00001343)=0.131260883708235E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.14451E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1343 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001343)=0.000000000000000E+00 beta (00001344)=0.133706680679121E+02 gamma(00001344)=0.133706680679121E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10734E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1344 z1= 1 0.677961597188621E-03 0.000000000000000E+00 z1= 2 -.233830429051341E-03 0.000000000000000E+00 z1= 3 0.438449898873041E-03 0.000000000000000E+00 alpha(00001344)=0.000000000000000E+00 beta (00001345)=0.131382391232174E+02 gamma(00001345)=0.131382391232174E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.88048E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1345 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001345)=0.000000000000000E+00 beta (00001346)=0.133869183817574E+02 gamma(00001346)=0.133869183817574E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11155E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1346 z1= 1 -.680430987049981E-03 0.000000000000000E+00 z1= 2 0.230321640704106E-03 0.000000000000000E+00 z1= 3 -.496086477690380E-03 0.000000000000000E+00 alpha(00001346)=0.000000000000000E+00 beta (00001347)=0.130843884435895E+02 gamma(00001347)=0.130843884435895E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.15803E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1347 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001347)=0.000000000000000E+00 beta (00001348)=0.134027772347900E+02 gamma(00001348)=0.134027772347900E+02 lr_calc_dens: Charge drift due to real space implementation = -0.35210E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1348 z1= 1 0.686038003896610E-03 0.000000000000000E+00 z1= 2 -.233198050299942E-03 0.000000000000000E+00 z1= 3 0.552402383189314E-03 0.000000000000000E+00 alpha(00001348)=0.000000000000000E+00 beta (00001349)=0.130655567738508E+02 gamma(00001349)=0.130655567738508E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.33026E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1349 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001349)=0.000000000000000E+00 beta (00001350)=0.134282238574282E+02 gamma(00001350)=0.134282238574282E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12478E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1350 z1= 1 -.681676825314462E-03 0.000000000000000E+00 z1= 2 0.228084104892613E-03 0.000000000000000E+00 z1= 3 -.363828374187011E-03 0.000000000000000E+00 alpha(00001350)=0.000000000000000E+00 beta (00001351)=0.131038309619796E+02 gamma(00001351)=0.131038309619796E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11086E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1351 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001351)=0.000000000000000E+00 beta (00001352)=0.133126818218993E+02 gamma(00001352)=0.133126818218993E+02 lr_calc_dens: Charge drift due to real space implementation = -0.48887E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1352 z1= 1 0.692329736688646E-03 0.000000000000000E+00 z1= 2 -.232887587837996E-03 0.000000000000000E+00 z1= 3 -.101262640084986E-03 0.000000000000000E+00 alpha(00001352)=0.000000000000000E+00 beta (00001353)=0.132223346953596E+02 gamma(00001353)=0.132223346953596E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12009E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1353 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001353)=0.000000000000000E+00 beta (00001354)=0.134501378189869E+02 gamma(00001354)=0.134501378189869E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11689E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1354 z1= 1 -.692959510686965E-03 0.000000000000000E+00 z1= 2 0.230851455241653E-03 0.000000000000000E+00 z1= 3 0.499284642559664E-03 0.000000000000000E+00 alpha(00001354)=0.000000000000000E+00 beta (00001355)=0.131207428304088E+02 gamma(00001355)=0.131207428304088E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.56643E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1355 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001355)=0.000000000000000E+00 beta (00001356)=0.133457942930196E+02 gamma(00001356)=0.133457942930196E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10588E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1356 z1= 1 0.699985603434808E-03 0.000000000000000E+00 z1= 2 -.234162684237382E-03 0.000000000000000E+00 z1= 3 -.564995774365997E-03 0.000000000000000E+00 alpha(00001356)=0.000000000000000E+00 beta (00001357)=0.130902056705921E+02 gamma(00001357)=0.130902056705921E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.23522E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1357 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001357)=0.000000000000000E+00 beta (00001358)=0.134960154065804E+02 gamma(00001358)=0.134960154065804E+02 lr_calc_dens: Charge drift due to real space implementation = 0.66111E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1358 z1= 1 -.688621535610154E-03 0.000000000000000E+00 z1= 2 0.228201681072501E-03 0.000000000000000E+00 z1= 3 0.373742548997783E-03 0.000000000000000E+00 alpha(00001358)=0.000000000000000E+00 beta (00001359)=0.130819498768416E+02 gamma(00001359)=0.130819498768416E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.30128E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1359 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001359)=0.000000000000000E+00 beta (00001360)=0.134165990342351E+02 gamma(00001360)=0.134165990342351E+02 lr_calc_dens: Charge drift due to real space implementation = -0.44730E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1360 z1= 1 0.688024592010894E-03 0.000000000000000E+00 z1= 2 -.227654827496215E-03 0.000000000000000E+00 z1= 3 -.146888251152107E-03 0.000000000000000E+00 alpha(00001360)=0.000000000000000E+00 beta (00001361)=0.130712727014604E+02 gamma(00001361)=0.130712727014604E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.48392E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1361 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001361)=0.000000000000000E+00 beta (00001362)=0.134655094336461E+02 gamma(00001362)=0.134655094336461E+02 lr_calc_dens: Charge drift due to real space implementation = 0.37771E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1362 z1= 1 -.676670333738122E-03 0.000000000000000E+00 z1= 2 0.221323732726883E-03 0.000000000000000E+00 z1= 3 0.371784800908483E-04 0.000000000000000E+00 alpha(00001362)=0.000000000000000E+00 beta (00001363)=0.132215371372474E+02 gamma(00001363)=0.132215371372474E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.65735E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1363 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001363)=0.000000000000000E+00 beta (00001364)=0.134124955746847E+02 gamma(00001364)=0.134124955746847E+02 lr_calc_dens: Charge drift due to real space implementation = -0.37482E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1364 z1= 1 0.682217858543315E-03 0.000000000000000E+00 z1= 2 -.221307145420609E-03 0.000000000000000E+00 z1= 3 -.130590871831595E-03 0.000000000000000E+00 alpha(00001364)=0.000000000000000E+00 beta (00001365)=0.131568202201287E+02 gamma(00001365)=0.131568202201287E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.96805E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1365 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001365)=0.000000000000000E+00 beta (00001366)=0.134088371733916E+02 gamma(00001366)=0.134088371733916E+02 lr_calc_dens: Charge drift due to real space implementation = 0.62565E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1366 z1= 1 -.676732285887151E-03 0.000000000000000E+00 z1= 2 0.218240340697929E-03 0.000000000000000E+00 z1= 3 0.488796522309496E-03 0.000000000000000E+00 alpha(00001366)=0.000000000000000E+00 beta (00001367)=0.130584018323687E+02 gamma(00001367)=0.130584018323687E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11388E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1367 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001367)=0.000000000000000E+00 beta (00001368)=0.133814150574602E+02 gamma(00001368)=0.133814150574602E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10745E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1368 z1= 1 0.672874721539501E-03 0.000000000000000E+00 z1= 2 -.216518723046320E-03 0.000000000000000E+00 z1= 3 -.926127804988686E-03 0.000000000000000E+00 alpha(00001368)=0.000000000000000E+00 beta (00001369)=0.129261087373902E+02 gamma(00001369)=0.129261087373902E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.90823E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1369 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001369)=0.000000000000000E+00 beta (00001370)=0.135237081222184E+02 gamma(00001370)=0.135237081222184E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12610E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1370 z1= 1 -.649665472761770E-03 0.000000000000000E+00 z1= 2 0.210916574331985E-03 0.000000000000000E+00 z1= 3 0.115418479610815E-02 0.000000000000000E+00 alpha(00001370)=0.000000000000000E+00 beta (00001371)=0.130141041331077E+02 gamma(00001371)=0.130141041331077E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.53792E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1371 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001371)=0.000000000000000E+00 beta (00001372)=0.135286946791664E+02 gamma(00001372)=0.135286946791664E+02 lr_calc_dens: Charge drift due to real space implementation = -0.13093E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1372 z1= 1 0.636833613818553E-03 0.000000000000000E+00 z1= 2 -.205759539999404E-03 0.000000000000000E+00 z1= 3 -.119991114580130E-02 0.000000000000000E+00 alpha(00001372)=0.000000000000000E+00 beta (00001373)=0.130553094664346E+02 gamma(00001373)=0.130553094664346E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.48511E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1373 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001373)=0.000000000000000E+00 beta (00001374)=0.134832539250651E+02 gamma(00001374)=0.134832539250651E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10643E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1374 z1= 1 -.623795196135805E-03 0.000000000000000E+00 z1= 2 0.204003729745974E-03 0.000000000000000E+00 z1= 3 0.988423962630224E-03 0.000000000000000E+00 alpha(00001374)=0.000000000000000E+00 beta (00001375)=0.129793156212967E+02 gamma(00001375)=0.129793156212967E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.44405E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1375 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001375)=0.000000000000000E+00 beta (00001376)=0.135410550055216E+02 gamma(00001376)=0.135410550055216E+02 lr_calc_dens: Charge drift due to real space implementation = -0.18557E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1376 z1= 1 0.609608821865771E-03 0.000000000000000E+00 z1= 2 -.197658223394253E-03 0.000000000000000E+00 z1= 3 -.555805022598055E-03 0.000000000000000E+00 alpha(00001376)=0.000000000000000E+00 beta (00001377)=0.130512762815520E+02 gamma(00001377)=0.130512762815520E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.46028E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1377 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001377)=0.000000000000000E+00 beta (00001378)=0.135406878013031E+02 gamma(00001378)=0.135406878013031E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11202E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1378 z1= 1 -.595681149132690E-03 0.000000000000000E+00 z1= 2 0.197298598818694E-03 0.000000000000000E+00 z1= 3 0.225044698135347E-03 0.000000000000000E+00 alpha(00001378)=0.000000000000000E+00 beta (00001379)=0.129830793140649E+02 gamma(00001379)=0.129830793140649E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.87365E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1379 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001379)=0.000000000000000E+00 beta (00001380)=0.134923309593198E+02 gamma(00001380)=0.134923309593198E+02 lr_calc_dens: Charge drift due to real space implementation = -0.51943E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1380 z1= 1 0.584787864497996E-03 0.000000000000000E+00 z1= 2 -.192226553605734E-03 0.000000000000000E+00 z1= 3 -.230680961264596E-03 0.000000000000000E+00 alpha(00001380)=0.000000000000000E+00 beta (00001381)=0.130601901270265E+02 gamma(00001381)=0.130601901270265E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.10228E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1381 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001381)=0.000000000000000E+00 beta (00001382)=0.134066608589727E+02 gamma(00001382)=0.134066608589727E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12937E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1382 z1= 1 -.578188151909242E-03 0.000000000000000E+00 z1= 2 0.194237124613147E-03 0.000000000000000E+00 z1= 3 0.433296377387950E-03 0.000000000000000E+00 alpha(00001382)=0.000000000000000E+00 beta (00001383)=0.130592321718408E+02 gamma(00001383)=0.130592321718408E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.36312E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1383 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001383)=0.000000000000000E+00 beta (00001384)=0.134750560652168E+02 gamma(00001384)=0.134750560652168E+02 lr_calc_dens: Charge drift due to real space implementation = -0.13513E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1384 z1= 1 0.570797213886872E-03 0.000000000000000E+00 z1= 2 -.188453748544773E-03 0.000000000000000E+00 z1= 3 -.445519046167790E-03 0.000000000000000E+00 alpha(00001384)=0.000000000000000E+00 beta (00001385)=0.131026302349218E+02 gamma(00001385)=0.131026302349218E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.34530E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1385 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001385)=0.000000000000000E+00 beta (00001386)=0.135211075354710E+02 gamma(00001386)=0.135211075354710E+02 lr_calc_dens: Charge drift due to real space implementation = 0.76978E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1386 z1= 1 -.561097172903993E-03 0.000000000000000E+00 z1= 2 0.189491830344239E-03 0.000000000000000E+00 z1= 3 0.185618681362128E-03 0.000000000000000E+00 alpha(00001386)=0.000000000000000E+00 beta (00001387)=0.130692109009132E+02 gamma(00001387)=0.130692109009132E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.50867E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1387 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001387)=0.000000000000000E+00 beta (00001388)=0.133573035977143E+02 gamma(00001388)=0.133573035977143E+02 lr_calc_dens: Charge drift due to real space implementation = -0.16516E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1388 z1= 1 0.556997900007260E-03 0.000000000000000E+00 z1= 2 -.185410002255664E-03 0.000000000000000E+00 z1= 3 0.155574709619209E-03 0.000000000000000E+00 alpha(00001388)=0.000000000000000E+00 beta (00001389)=0.130635994928870E+02 gamma(00001389)=0.130635994928870E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.19935E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1389 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001389)=0.000000000000000E+00 beta (00001390)=0.133545619705067E+02 gamma(00001390)=0.133545619705067E+02 lr_calc_dens: Charge drift due to real space implementation = -0.14983E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1390 z1= 1 -.550746086709404E-03 0.000000000000000E+00 z1= 2 0.188361005297269E-03 0.000000000000000E+00 z1= 3 -.346954890612559E-03 0.000000000000000E+00 alpha(00001390)=0.000000000000000E+00 beta (00001391)=0.130620601181471E+02 gamma(00001391)=0.130620601181471E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.41841E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1391 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001391)=0.000000000000000E+00 beta (00001392)=0.134365259396425E+02 gamma(00001392)=0.134365259396425E+02 lr_calc_dens: Charge drift due to real space implementation = -0.14774E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1392 z1= 1 0.539941584904460E-03 0.000000000000000E+00 z1= 2 -.180725742180164E-03 0.000000000000000E+00 z1= 3 0.284756171472302E-03 0.000000000000000E+00 alpha(00001392)=0.000000000000000E+00 beta (00001393)=0.130855796155134E+02 gamma(00001393)=0.130855796155134E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.76768E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1393 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001393)=0.000000000000000E+00 beta (00001394)=0.133855815252217E+02 gamma(00001394)=0.133855815252217E+02 lr_calc_dens: Charge drift due to real space implementation = 0.87247E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1394 z1= 1 -.533571798117390E-03 0.000000000000000E+00 z1= 2 0.183049674947853E-03 0.000000000000000E+00 z1= 3 -.902620308050328E-04 0.000000000000000E+00 alpha(00001394)=0.000000000000000E+00 beta (00001395)=0.131615727587200E+02 gamma(00001395)=0.131615727587200E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.28274E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1395 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001395)=0.000000000000000E+00 beta (00001396)=0.133747202819271E+02 gamma(00001396)=0.133747202819271E+02 lr_calc_dens: Charge drift due to real space implementation = -0.96659E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1396 z1= 1 0.528624938830745E-03 0.000000000000000E+00 z1= 2 -.176495337534267E-03 0.000000000000000E+00 z1= 3 0.299948037549187E-04 0.000000000000000E+00 alpha(00001396)=0.000000000000000E+00 beta (00001397)=0.129846795437995E+02 gamma(00001397)=0.129846795437995E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.27097E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1397 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001397)=0.000000000000000E+00 beta (00001398)=0.134825619236328E+02 gamma(00001398)=0.134825619236328E+02 lr_calc_dens: Charge drift due to real space implementation = 0.38539E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1398 z1= 1 -.514639964564831E-03 0.000000000000000E+00 z1= 2 0.176549937127994E-03 0.000000000000000E+00 z1= 3 -.161572586688759E-03 0.000000000000000E+00 alpha(00001398)=0.000000000000000E+00 beta (00001399)=0.130749601320585E+02 gamma(00001399)=0.130749601320585E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.94403E-10 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1399 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001399)=0.000000000000000E+00 beta (00001400)=0.134357182010969E+02 gamma(00001400)=0.134357182010969E+02 lr_calc_dens: Charge drift due to real space implementation = -0.32769E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1400 z1= 1 0.502162422121932E-03 0.000000000000000E+00 z1= 2 -.167809603702227E-03 0.000000000000000E+00 z1= 3 0.405865563931178E-03 0.000000000000000E+00 alpha(00001400)=0.000000000000000E+00 beta (00001401)=0.130249687066104E+02 gamma(00001401)=0.130249687066104E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14994E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1401 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001401)=0.000000000000000E+00 beta (00001402)=0.133699430430940E+02 gamma(00001402)=0.133699430430940E+02 lr_calc_dens: Charge drift due to real space implementation = 0.53465E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1402 z1= 1 -.493291253142077E-03 0.000000000000000E+00 z1= 2 0.170091312818668E-03 0.000000000000000E+00 z1= 3 -.759803566756931E-03 0.000000000000000E+00 alpha(00001402)=0.000000000000000E+00 beta (00001403)=0.131439943554271E+02 gamma(00001403)=0.131439943554271E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.23555E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1403 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001403)=0.000000000000000E+00 beta (00001404)=0.133522676105137E+02 gamma(00001404)=0.133522676105137E+02 lr_calc_dens: Charge drift due to real space implementation = -0.13367E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1404 z1= 1 0.484379287712497E-03 0.000000000000000E+00 z1= 2 -.162873127399515E-03 0.000000000000000E+00 z1= 3 0.113769800396603E-02 0.000000000000000E+00 alpha(00001404)=0.000000000000000E+00 beta (00001405)=0.131091012070647E+02 gamma(00001405)=0.131091012070647E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.26925E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1405 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001405)=0.000000000000000E+00 beta (00001406)=0.134419735914796E+02 gamma(00001406)=0.134419735914796E+02 lr_calc_dens: Charge drift due to real space implementation = -0.33313E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1406 z1= 1 -.476394512291874E-03 0.000000000000000E+00 z1= 2 0.166674010129702E-03 0.000000000000000E+00 z1= 3 -.129696181170156E-02 0.000000000000000E+00 alpha(00001406)=0.000000000000000E+00 beta (00001407)=0.131064879355548E+02 gamma(00001407)=0.131064879355548E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.23854E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1407 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001407)=0.000000000000000E+00 beta (00001408)=0.134711203640506E+02 gamma(00001408)=0.134711203640506E+02 lr_calc_dens: Charge drift due to real space implementation = 0.31275E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1408 z1= 1 0.460845741007903E-03 0.000000000000000E+00 z1= 2 -.155606785710370E-03 0.000000000000000E+00 z1= 3 0.994075273287256E-03 0.000000000000000E+00 alpha(00001408)=0.000000000000000E+00 beta (00001409)=0.132037402445990E+02 gamma(00001409)=0.132037402445990E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.83639E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1409 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001409)=0.000000000000000E+00 beta (00001410)=0.133453970776166E+02 gamma(00001410)=0.133453970776166E+02 lr_calc_dens: Charge drift due to real space implementation = 0.35294E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1410 z1= 1 -.459866174132328E-03 0.000000000000000E+00 z1= 2 0.161066891240976E-03 0.000000000000000E+00 z1= 3 -.332281744012772E-03 0.000000000000000E+00 alpha(00001410)=0.000000000000000E+00 beta (00001411)=0.131470221021357E+02 gamma(00001411)=0.131470221021357E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.90115E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1411 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001411)=0.000000000000000E+00 beta (00001412)=0.135094293786862E+02 gamma(00001412)=0.135094293786862E+02 lr_calc_dens: Charge drift due to real space implementation = -0.10526E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1412 z1= 1 0.442656887629345E-03 0.000000000000000E+00 z1= 2 -.150165500535475E-03 0.000000000000000E+00 z1= 3 -.224748991755813E-03 0.000000000000000E+00 alpha(00001412)=0.000000000000000E+00 beta (00001413)=0.132092323399663E+02 gamma(00001413)=0.132092323399663E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.29135E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1413 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001413)=0.000000000000000E+00 beta (00001414)=0.134774750522480E+02 gamma(00001414)=0.134774750522480E+02 lr_calc_dens: Charge drift due to real space implementation = 0.11598E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1414 z1= 1 -.436183695943536E-03 0.000000000000000E+00 z1= 2 0.155259383078294E-03 0.000000000000000E+00 z1= 3 0.334304964542651E-03 0.000000000000000E+00 alpha(00001414)=0.000000000000000E+00 beta (00001415)=0.130377570487159E+02 gamma(00001415)=0.130377570487159E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.47058E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1415 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001415)=0.000000000000000E+00 beta (00001416)=0.134068039392970E+02 gamma(00001416)=0.134068039392970E+02 lr_calc_dens: Charge drift due to real space implementation = -0.42922E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1416 z1= 1 0.418243704193126E-03 0.000000000000000E+00 z1= 2 -.145955005909748E-03 0.000000000000000E+00 z1= 3 -.522617568354013E-04 0.000000000000000E+00 alpha(00001416)=0.000000000000000E+00 beta (00001417)=0.131727675755977E+02 gamma(00001417)=0.131727675755977E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.56006E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1417 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001417)=0.000000000000000E+00 beta (00001418)=0.134130230167041E+02 gamma(00001418)=0.134130230167041E+02 lr_calc_dens: Charge drift due to real space implementation = -0.32715E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1418 z1= 1 -.412580708997667E-03 0.000000000000000E+00 z1= 2 0.149033989815332E-03 0.000000000000000E+00 z1= 3 -.220970023459820E-03 0.000000000000000E+00 alpha(00001418)=0.000000000000000E+00 beta (00001419)=0.131716063656441E+02 gamma(00001419)=0.131716063656441E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12631E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1419 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001419)=0.000000000000000E+00 beta (00001420)=0.134012944300543E+02 gamma(00001420)=0.134012944300543E+02 lr_calc_dens: Charge drift due to real space implementation = 0.25879E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1420 z1= 1 0.399316863503823E-03 0.000000000000000E+00 z1= 2 -.141404374604733E-03 0.000000000000000E+00 z1= 3 0.214014642285194E-03 0.000000000000000E+00 alpha(00001420)=0.000000000000000E+00 beta (00001421)=0.131812642758136E+02 gamma(00001421)=0.131812642758136E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.60756E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1421 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001421)=0.000000000000000E+00 beta (00001422)=0.134646174840419E+02 gamma(00001422)=0.134646174840419E+02 lr_calc_dens: Charge drift due to real space implementation = 0.36716E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1422 z1= 1 -.391799163024788E-03 0.000000000000000E+00 z1= 2 0.142273690093430E-03 0.000000000000000E+00 z1= 3 -.611789618572139E-04 0.000000000000000E+00 alpha(00001422)=0.000000000000000E+00 beta (00001423)=0.129724228862978E+02 gamma(00001423)=0.129724228862978E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.33582E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1423 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001423)=0.000000000000000E+00 beta (00001424)=0.133532350500228E+02 gamma(00001424)=0.133532350500228E+02 lr_calc_dens: Charge drift due to real space implementation = -0.53135E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1424 z1= 1 0.373490342439733E-03 0.000000000000000E+00 z1= 2 -.135941417922201E-03 0.000000000000000E+00 z1= 3 -.548644676098900E-04 0.000000000000000E+00 alpha(00001424)=0.000000000000000E+00 beta (00001425)=0.130797837282519E+02 gamma(00001425)=0.130797837282519E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.48982E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1425 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001425)=0.000000000000000E+00 beta (00001426)=0.134632513267374E+02 gamma(00001426)=0.134632513267374E+02 lr_calc_dens: Charge drift due to real space implementation = 0.20617E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1426 z1= 1 -.361769462148860E-03 0.000000000000000E+00 z1= 2 0.134090704056145E-03 0.000000000000000E+00 z1= 3 0.149341824085185E-03 0.000000000000000E+00 alpha(00001426)=0.000000000000000E+00 beta (00001427)=0.131889249714648E+02 gamma(00001427)=0.131889249714648E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.11109E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1427 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001427)=0.000000000000000E+00 beta (00001428)=0.133718201296236E+02 gamma(00001428)=0.133718201296236E+02 lr_calc_dens: Charge drift due to real space implementation = -0.14080E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1428 z1= 1 0.348596389328288E-03 0.000000000000000E+00 z1= 2 -.129392613743316E-03 0.000000000000000E+00 z1= 3 -.320820819838256E-03 0.000000000000000E+00 alpha(00001428)=0.000000000000000E+00 beta (00001429)=0.130382526620095E+02 gamma(00001429)=0.130382526620095E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.33835E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1429 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001429)=0.000000000000000E+00 beta (00001430)=0.134034474125187E+02 gamma(00001430)=0.134034474125187E+02 lr_calc_dens: Charge drift due to real space implementation = 0.42350E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1430 z1= 1 -.335282768935867E-03 0.000000000000000E+00 z1= 2 0.123905015613901E-03 0.000000000000000E+00 z1= 3 0.410942699469690E-03 0.000000000000000E+00 alpha(00001430)=0.000000000000000E+00 beta (00001431)=0.130570442489856E+02 gamma(00001431)=0.130570442489856E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.14580E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1431 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001431)=0.000000000000000E+00 beta (00001432)=0.134098942056900E+02 gamma(00001432)=0.134098942056900E+02 lr_calc_dens: Charge drift due to real space implementation = -0.43358E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1432 z1= 1 0.316737542019023E-03 0.000000000000000E+00 z1= 2 -.117064892064437E-03 0.000000000000000E+00 z1= 3 -.213914659132576E-03 0.000000000000000E+00 alpha(00001432)=0.000000000000000E+00 beta (00001433)=0.130471238975851E+02 gamma(00001433)=0.130471238975851E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.15995E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1433 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001433)=0.000000000000000E+00 beta (00001434)=0.134667924272129E+02 gamma(00001434)=0.134667924272129E+02 lr_calc_dens: Charge drift due to real space implementation = 0.58502E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1434 z1= 1 -.302177362062056E-03 0.000000000000000E+00 z1= 2 0.110158960265491E-03 0.000000000000000E+00 z1= 3 -.161923294211009E-03 0.000000000000000E+00 alpha(00001434)=0.000000000000000E+00 beta (00001435)=0.130108334085198E+02 gamma(00001435)=0.130108334085198E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.46737E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1435 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001435)=0.000000000000000E+00 beta (00001436)=0.134404746006315E+02 gamma(00001436)=0.134404746006315E+02 lr_calc_dens: Charge drift due to real space implementation = 0.21825E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1436 z1= 1 0.282630362854162E-03 0.000000000000000E+00 z1= 2 -.103358979959623E-03 0.000000000000000E+00 z1= 3 0.513825715410001E-03 0.000000000000000E+00 alpha(00001436)=0.000000000000000E+00 beta (00001437)=0.129955026926558E+02 gamma(00001437)=0.129955026926558E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.35115E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1437 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001437)=0.000000000000000E+00 beta (00001438)=0.135244496281478E+02 gamma(00001438)=0.135244496281478E+02 lr_calc_dens: Charge drift due to real space implementation = -0.14789E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1438 z1= 1 -.265734550955590E-03 0.000000000000000E+00 z1= 2 0.939485027825013E-04 0.000000000000000E+00 z1= 3 -.677805569909085E-03 0.000000000000000E+00 alpha(00001438)=0.000000000000000E+00 beta (00001439)=0.131028420332881E+02 gamma(00001439)=0.131028420332881E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.50628E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1439 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001439)=0.000000000000000E+00 beta (00001440)=0.134351560609232E+02 gamma(00001440)=0.134351560609232E+02 lr_calc_dens: Charge drift due to real space implementation = -0.27181E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1440 z1= 1 0.248242024891378E-03 0.000000000000000E+00 z1= 2 -.890142652219279E-04 0.000000000000000E+00 z1= 3 0.693198212114219E-03 0.000000000000000E+00 alpha(00001440)=0.000000000000000E+00 beta (00001441)=0.130388951932088E+02 gamma(00001441)=0.130388951932088E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.39743E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1441 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001441)=0.000000000000000E+00 beta (00001442)=0.134894417131363E+02 gamma(00001442)=0.134894417131363E+02 lr_calc_dens: Charge drift due to real space implementation = 0.42175E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1442 z1= 1 -.233679309264948E-03 0.000000000000000E+00 z1= 2 0.802554444610630E-04 0.000000000000000E+00 z1= 3 -.716406506074348E-03 0.000000000000000E+00 alpha(00001442)=0.000000000000000E+00 beta (00001443)=0.129979099352333E+02 gamma(00001443)=0.129979099352333E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12865E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1443 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001443)=0.000000000000000E+00 beta (00001444)=0.134023414557222E+02 gamma(00001444)=0.134023414557222E+02 lr_calc_dens: Charge drift due to real space implementation = -0.16059E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1444 z1= 1 0.214854561133947E-03 0.000000000000000E+00 z1= 2 -.759385507726716E-04 0.000000000000000E+00 z1= 3 0.779080305248481E-03 0.000000000000000E+00 alpha(00001444)=0.000000000000000E+00 beta (00001445)=0.129947182479816E+02 gamma(00001445)=0.129947182479816E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.20747E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1445 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001445)=0.000000000000000E+00 beta (00001446)=0.135326319006694E+02 gamma(00001446)=0.135326319006694E+02 lr_calc_dens: Charge drift due to real space implementation = -0.29028E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1446 z1= 1 -.197697578279518E-03 0.000000000000000E+00 z1= 2 0.660740151040653E-04 0.000000000000000E+00 z1= 3 -.841857640898905E-03 0.000000000000000E+00 alpha(00001446)=0.000000000000000E+00 beta (00001447)=0.130099983501507E+02 gamma(00001447)=0.130099983501507E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.58477E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1447 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001447)=0.000000000000000E+00 beta (00001448)=0.134554956639030E+02 gamma(00001448)=0.134554956639030E+02 lr_calc_dens: Charge drift due to real space implementation = -0.20292E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1448 z1= 1 0.176892679175752E-03 0.000000000000000E+00 z1= 2 -.630893534302383E-04 0.000000000000000E+00 z1= 3 0.101205926482030E-02 0.000000000000000E+00 alpha(00001448)=0.000000000000000E+00 beta (00001449)=0.131422261479025E+02 gamma(00001449)=0.131422261479025E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.60285E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1449 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001449)=0.000000000000000E+00 beta (00001450)=0.135067006314055E+02 gamma(00001450)=0.135067006314055E+02 lr_calc_dens: Charge drift due to real space implementation = 0.43352E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1450 z1= 1 -.162701434138175E-03 0.000000000000000E+00 z1= 2 0.533752916861696E-04 0.000000000000000E+00 z1= 3 -.127249487617660E-02 0.000000000000000E+00 alpha(00001450)=0.000000000000000E+00 beta (00001451)=0.131012450586652E+02 gamma(00001451)=0.131012450586652E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.19158E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1451 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001451)=0.000000000000000E+00 beta (00001452)=0.134477987233657E+02 gamma(00001452)=0.134477987233657E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12110E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1452 z1= 1 0.144372391639431E-03 0.000000000000000E+00 z1= 2 -.499756639086150E-04 0.000000000000000E+00 z1= 3 0.160790059289388E-02 0.000000000000000E+00 alpha(00001452)=0.000000000000000E+00 beta (00001453)=0.130134594647861E+02 gamma(00001453)=0.130134594647861E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.46224E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1453 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001453)=0.000000000000000E+00 beta (00001454)=0.135909280728241E+02 gamma(00001454)=0.135909280728241E+02 lr_calc_dens: Charge drift due to real space implementation = -0.44316E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1454 z1= 1 -.128655998297368E-03 0.000000000000000E+00 z1= 2 0.384838730689836E-04 0.000000000000000E+00 z1= 3 -.177518500597261E-02 0.000000000000000E+00 alpha(00001454)=0.000000000000000E+00 beta (00001455)=0.130664580006871E+02 gamma(00001455)=0.130664580006871E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.12337E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1455 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001455)=0.000000000000000E+00 beta (00001456)=0.134338843568592E+02 gamma(00001456)=0.134338843568592E+02 lr_calc_dens: Charge drift due to real space implementation = -0.20182E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1456 z1= 1 0.109482641092404E-03 0.000000000000000E+00 z1= 2 -.340728415717199E-04 0.000000000000000E+00 z1= 3 0.160767531466307E-02 0.000000000000000E+00 alpha(00001456)=0.000000000000000E+00 beta (00001457)=0.130437973133901E+02 gamma(00001457)=0.130437973133901E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12603E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1457 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001457)=0.000000000000000E+00 beta (00001458)=0.134917342074387E+02 gamma(00001458)=0.134917342074387E+02 lr_calc_dens: Charge drift due to real space implementation = 0.84951E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1458 z1= 1 -.933104196159541E-04 0.000000000000000E+00 z1= 2 0.228376780333100E-04 0.000000000000000E+00 z1= 3 -.119802061628902E-02 0.000000000000000E+00 alpha(00001458)=0.000000000000000E+00 beta (00001459)=0.130949809209343E+02 gamma(00001459)=0.130949809209343E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.60301E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1459 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001459)=0.000000000000000E+00 beta (00001460)=0.134715233054601E+02 gamma(00001460)=0.134715233054601E+02 lr_calc_dens: Charge drift due to real space implementation = -0.61172E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1460 z1= 1 0.719719275011806E-04 0.000000000000000E+00 z1= 2 -.173462687316777E-04 0.000000000000000E+00 z1= 3 0.751164357390824E-03 0.000000000000000E+00 alpha(00001460)=0.000000000000000E+00 beta (00001461)=0.130469198559493E+02 gamma(00001461)=0.130469198559493E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.35062E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1461 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001461)=0.000000000000000E+00 beta (00001462)=0.134947054816075E+02 gamma(00001462)=0.134947054816075E+02 lr_calc_dens: Charge drift due to real space implementation = 0.68796E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1462 z1= 1 -.549137550422633E-04 0.000000000000000E+00 z1= 2 0.613079800279148E-05 0.000000000000000E+00 z1= 3 -.337904244683706E-03 0.000000000000000E+00 alpha(00001462)=0.000000000000000E+00 beta (00001463)=0.130438702128329E+02 gamma(00001463)=0.130438702128329E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.90283E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1463 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001463)=0.000000000000000E+00 beta (00001464)=0.134286729210329E+02 gamma(00001464)=0.134286729210329E+02 lr_calc_dens: Charge drift due to real space implementation = -0.28041E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1464 z1= 1 0.330073751256699E-04 0.000000000000000E+00 z1= 2 0.126623537559031E-05 0.000000000000000E+00 z1= 3 -.440460549682134E-04 0.000000000000000E+00 alpha(00001464)=0.000000000000000E+00 beta (00001465)=0.130078716171095E+02 gamma(00001465)=0.130078716171095E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.12643E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1465 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001465)=0.000000000000000E+00 beta (00001466)=0.133548815913226E+02 gamma(00001466)=0.133548815913226E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10644E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1466 z1= 1 -.164479328687954E-04 0.000000000000000E+00 z1= 2 -.112559789122346E-04 0.000000000000000E+00 z1= 3 0.232943015243997E-03 0.000000000000000E+00 alpha(00001466)=0.000000000000000E+00 beta (00001467)=0.130247653322975E+02 gamma(00001467)=0.130247653322975E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.58896E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1467 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001467)=0.000000000000000E+00 beta (00001468)=0.134822604138515E+02 gamma(00001468)=0.134822604138515E+02 lr_calc_dens: Charge drift due to real space implementation = -0.93928E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1468 z1= 1 -.550266999538307E-05 0.000000000000000E+00 z1= 2 0.192257447801324E-04 0.000000000000000E+00 z1= 3 0.431452123896832E-04 0.000000000000000E+00 alpha(00001468)=0.000000000000000E+00 beta (00001469)=0.130869363250742E+02 gamma(00001469)=0.130869363250742E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.69645E-10 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1469 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001469)=0.000000000000000E+00 beta (00001470)=0.134949927151417E+02 gamma(00001470)=0.134949927151417E+02 lr_calc_dens: Charge drift due to real space implementation = 0.28912E-10 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1470 z1= 1 0.223623012535175E-04 0.000000000000000E+00 z1= 2 -.271203333111372E-04 0.000000000000000E+00 z1= 3 -.580925128354589E-03 0.000000000000000E+00 alpha(00001470)=0.000000000000000E+00 beta (00001471)=0.129103429027529E+02 gamma(00001471)=0.129103429027529E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.52718E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1471 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001471)=0.000000000000000E+00 beta (00001472)=0.133966947073632E+02 gamma(00001472)=0.133966947073632E+02 lr_calc_dens: Charge drift due to real space implementation = 0.36673E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1472 z1= 1 -.451661494540265E-04 0.000000000000000E+00 z1= 2 0.364058424813505E-04 0.000000000000000E+00 z1= 3 0.854717332881061E-03 0.000000000000000E+00 alpha(00001472)=0.000000000000000E+00 beta (00001473)=0.130285674864648E+02 gamma(00001473)=0.130285674864648E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14893E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1473 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001473)=0.000000000000000E+00 beta (00001474)=0.134711587517808E+02 gamma(00001474)=0.134711587517808E+02 lr_calc_dens: Charge drift due to real space implementation = 0.38814E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1474 z1= 1 0.619853637061785E-04 0.000000000000000E+00 z1= 2 -.434662084759429E-04 0.000000000000000E+00 z1= 3 -.639351570224972E-03 0.000000000000000E+00 alpha(00001474)=0.000000000000000E+00 beta (00001475)=0.130071717474673E+02 gamma(00001475)=0.130071717474673E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.16106E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1475 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001475)=0.000000000000000E+00 beta (00001476)=0.133809204034247E+02 gamma(00001476)=0.133809204034247E+02 lr_calc_dens: Charge drift due to real space implementation = -0.12525E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1476 z1= 1 -.852835360057331E-04 0.000000000000000E+00 z1= 2 0.543454892932304E-04 0.000000000000000E+00 z1= 3 0.267553433381628E-03 0.000000000000000E+00 alpha(00001476)=0.000000000000000E+00 beta (00001477)=0.131088763140643E+02 gamma(00001477)=0.131088763140643E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.79708E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1477 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001477)=0.000000000000000E+00 beta (00001478)=0.135191611857828E+02 gamma(00001478)=0.135191611857828E+02 lr_calc_dens: Charge drift due to real space implementation = 0.12968E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1478 z1= 1 0.100762614854550E-03 0.000000000000000E+00 z1= 2 -.600125049013962E-04 0.000000000000000E+00 z1= 3 -.209097494962558E-03 0.000000000000000E+00 alpha(00001478)=0.000000000000000E+00 beta (00001479)=0.131154708109883E+02 gamma(00001479)=0.131154708109883E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.54168E-09 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1479 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001479)=0.000000000000000E+00 beta (00001480)=0.134489058151230E+02 gamma(00001480)=0.134489058151230E+02 lr_calc_dens: Charge drift due to real space implementation = -0.41857E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1480 z1= 1 -.123792520258638E-03 0.000000000000000E+00 z1= 2 0.725288302803264E-04 0.000000000000000E+00 z1= 3 0.422242098773829E-03 0.000000000000000E+00 alpha(00001480)=0.000000000000000E+00 beta (00001481)=0.130189241539201E+02 gamma(00001481)=0.130189241539201E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.14304E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1481 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001481)=0.000000000000000E+00 beta (00001482)=0.136917268432403E+02 gamma(00001482)=0.136917268432403E+02 lr_calc_dens: Charge drift due to real space implementation = -0.41869E-09 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1482 z1= 1 0.135991165070634E-03 0.000000000000000E+00 z1= 2 -.752290457375778E-04 0.000000000000000E+00 z1= 3 -.438729959873232E-03 0.000000000000000E+00 alpha(00001482)=0.000000000000000E+00 beta (00001483)=0.129654564994058E+02 gamma(00001483)=0.129654564994058E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.85343E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1483 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001483)=0.000000000000000E+00 beta (00001484)=0.134787369649144E+02 gamma(00001484)=0.134787369649144E+02 lr_calc_dens: Charge drift due to real space implementation = -0.35629E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1484 z1= 1 -.159108501533492E-03 0.000000000000000E+00 z1= 2 0.880549487041549E-04 0.000000000000000E+00 z1= 3 0.915365909387369E-04 0.000000000000000E+00 alpha(00001484)=0.000000000000000E+00 beta (00001485)=0.130485146577302E+02 gamma(00001485)=0.130485146577302E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.11478E-07 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1485 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001485)=0.000000000000000E+00 beta (00001486)=0.134508397906880E+02 gamma(00001486)=0.134508397906880E+02 lr_calc_dens: Charge drift due to real space implementation = 0.10045E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1486 z1= 1 0.175587540888191E-03 0.000000000000000E+00 z1= 2 -.920249738915711E-04 0.000000000000000E+00 z1= 3 0.303484106641872E-03 0.000000000000000E+00 alpha(00001486)=0.000000000000000E+00 beta (00001487)=0.130388043130634E+02 gamma(00001487)=0.130388043130634E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.82798E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1487 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001487)=0.000000000000000E+00 beta (00001488)=0.135641397497955E+02 gamma(00001488)=0.135641397497955E+02 lr_calc_dens: Charge drift due to real space implementation = -0.11294E-07 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1488 z1= 1 -.198798149231932E-03 0.000000000000000E+00 z1= 2 0.105439807245569E-03 0.000000000000000E+00 z1= 3 -.409314483819093E-03 0.000000000000000E+00 alpha(00001488)=0.000000000000000E+00 beta (00001489)=0.129963394417297E+02 gamma(00001489)=0.129963394417297E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.38887E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1489 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001489)=0.000000000000000E+00 beta (00001490)=0.136103736353892E+02 gamma(00001490)=0.136103736353892E+02 lr_calc_dens: Charge drift due to real space implementation = 0.65148E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1490 z1= 1 0.212784133746063E-03 0.000000000000000E+00 z1= 2 -.106061566442392E-03 0.000000000000000E+00 z1= 3 0.189061193301405E-03 0.000000000000000E+00 alpha(00001490)=0.000000000000000E+00 beta (00001491)=0.128993674501940E+02 gamma(00001491)=0.128993674501940E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.44263E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1491 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001491)=0.000000000000000E+00 beta (00001492)=0.135496915882914E+02 gamma(00001492)=0.135496915882914E+02 lr_calc_dens: Charge drift due to real space implementation = -0.24546E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1492 z1= 1 -.234915509318119E-03 0.000000000000000E+00 z1= 2 0.117865741347572E-03 0.000000000000000E+00 z1= 3 0.123639871603722E-03 0.000000000000000E+00 alpha(00001492)=0.000000000000000E+00 beta (00001493)=0.130140322585646E+02 gamma(00001493)=0.130140322585646E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.80518E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1493 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001493)=0.000000000000000E+00 beta (00001494)=0.136007705166802E+02 gamma(00001494)=0.136007705166802E+02 lr_calc_dens: Charge drift due to real space implementation = 0.39606E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1494 z1= 1 0.250728020921359E-03 0.000000000000000E+00 z1= 2 -.118388243807077E-03 0.000000000000000E+00 z1= 3 -.268170273353614E-03 0.000000000000000E+00 alpha(00001494)=0.000000000000000E+00 beta (00001495)=0.129445732647715E+02 gamma(00001495)=0.129445732647715E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.79963E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1495 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001495)=0.000000000000000E+00 beta (00001496)=0.134733861339133E+02 gamma(00001496)=0.134733861339133E+02 lr_calc_dens: Charge drift due to real space implementation = -0.52364E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1496 z1= 1 -.275312535867688E-03 0.000000000000000E+00 z1= 2 0.132484091285492E-03 0.000000000000000E+00 z1= 3 0.236495807454313E-03 0.000000000000000E+00 alpha(00001496)=0.000000000000000E+00 beta (00001497)=0.130169682096537E+02 gamma(00001497)=0.130169682096537E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.62988E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1497 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001497)=0.000000000000000E+00 beta (00001498)=0.134925386887754E+02 gamma(00001498)=0.134925386887754E+02 lr_calc_dens: Charge drift due to real space implementation = 0.48076E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1498 z1= 1 0.293421910835217E-03 0.000000000000000E+00 z1= 2 -.135649938438697E-03 0.000000000000000E+00 z1= 3 -.918126453085671E-04 0.000000000000000E+00 alpha(00001498)=0.000000000000000E+00 beta (00001499)=0.130971840281789E+02 gamma(00001499)=0.130971840281789E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = -0.69458E-08 lr_apply_liouvillian: applying interaction: normal Lanczos iteration: 1499 z1= 1 0.000000000000000E+00 0.000000000000000E+00 z1= 2 0.000000000000000E+00 0.000000000000000E+00 z1= 3 0.000000000000000E+00 0.000000000000000E+00 alpha(00001499)=0.000000000000000E+00 beta (00001500)=0.134786606691391E+02 gamma(00001500)=0.134786606691391E+02 lr_calc_dens: Charge drift due to real space implementation = -0.54078E-08 lr_apply_liouvillian: applying interaction: normal lr_apply_liouvillian: not applying interaction Lanczos iteration: 1500 z1= 1 -.319907377764419E-03 0.000000000000000E+00 z1= 2 0.153088211067238E-03 0.000000000000000E+00 z1= 3 -.129038204876990E-03 0.000000000000000E+00 alpha(00001500)=0.000000000000000E+00 beta (00001501)=0.130090945194817E+02 gamma(00001501)=0.130090945194817E+02 lr_apply_liouvillian: not applying interaction lr_calc_dens: Charge drift due to real space implementation = 0.93469E-08 lr_apply_liouvillian: applying interaction: normal End of Lanczos iterations Finished linear response calculation... lr_main : 14676.14s CPU 16614.78s WALL ( 1 calls) lr_solve_e : 25.57s CPU 27.79s WALL ( 1 calls) one_step : 14643.19s CPU 16577.72s WALL ( 4500 calls) lr_apply : 14321.26s CPU 16221.72s WALL ( 9006 calls) lr_apply_int : 11147.00s CPU 12694.41s WALL ( 4503 calls) lr_apply_no : 3174.25s CPU 3527.31s WALL ( 4503 calls) lr_apply : 14321.26s CPU 16221.72s WALL ( 9006 calls) h_psi : 6024.08s CPU 6706.86s WALL ( 9006 calls) lr_calc_dens : 3217.06s CPU 3652.46s WALL ( 4503 calls) lr_ortho : 97.14s CPU 106.51s WALL ( 9000 calls) interaction : 1374.84s CPU 1543.66s WALL ( 4503 calls) lr_dot : 52.57s CPU 56.05s WALL ( 11253 calls) US routines s_psi : 99.82s CPU 109.18s WALL ( 13636 calls) lr_sm1_psi : 258.30s CPU 287.93s WALL ( 9009 calls) General routines calbec : 500.82s CPU 547.73s WALL ( 27163 calls) fft : 3227.73s CPU 3701.17s WALL ( 18016 calls) ffts : 481.16s CPU 550.80s WALL ( 9007 calls) fftw : 7791.10s CPU 8635.43s WALL ( 216834 calls) interpolate : 2228.35s CPU 2635.72s WALL ( 9007 calls) davcio : 0.00s CPU 0.16s WALL ( 97 calls) addusdens : 0.01s CPU 0.01s WALL ( 4503 calls) Parallel routines fft_scatter : 5192.45s CPU 5750.21s WALL ( 243857 calls) TDDFPT : 4h 4m CPU 4h36m WALL This run was terminated on: 17:56:46 12Jan2012 =------------------------------------------------------------------------------= JOB DONE. =------------------------------------------------------------------------------= TDDFPT/Examples/Benzene/Benzene.tddfpt_pp-in0000644000175000017500000000025412341371500017164 0ustar mbamba&lr_input prefix='benzene', outdir='./out', itermax=10000 itermax0=450 extrapolation="osc" epsil=0.01 end=3.50d0 increment=0.001d0 start=0.0d0 ipol=4 / TDDFPT/Examples/Benzene/Benzene.pw-ref0000644000175000017500000002762312341371500016005 0ustar mbamba Program PWSCF v.4.99 starts on 12Jan2012 at 11:54:45 This program is part of the open-source Quantum ESPRESSO suite for quantum simulation of materials; please cite "P. Giannozzi et al., J. Phys.:Condens. Matter 21 395502 (2009); URL http://www.quantum-espresso.org", in publications or presentations arising from this work. More details at http://www.quantum-espresso.org/quote.php Parallel version (MPI), running on 4 processors R & G space division: proc/pool = 4 Current dimensions of program PWSCF are: Max number of different atomic species (ntypx) = 10 Max number of k-points (npk) = 40000 Max angular momentum in pseudopotentials (lmaxx) = 3 Waiting for input... Reading input from stdin file C.pz-rrkjus.UPF: wavefunction(s) 2S renormalized file H.pz-rrkjus.UPF: wavefunction(s) 1S renormalized gamma-point specific algorithms are used Subspace diagonalization in iterative solution of the eigenvalue problem: a serial algorithm will be used Parallelization info -------------------- sticks: dense smooth PW G-vecs: dense smooth PW Min 5091 2030 506 453838 114774 14329 Max 5094 2031 508 453840 114819 14336 Sum 20369 8121 2029 1815357 459173 57327 Tot 10185 4061 1015 Title: TDDFPT benzene test bravais-lattice index = 6 lattice parameter (alat) = 32.0000 a.u. unit-cell volume = 27197.4400 (a.u.)^3 number of atoms/cell = 12 number of atomic types = 2 number of electrons = 30.00 number of Kohn-Sham states= 15 kinetic-energy cutoff = 25.0000 Ry charge density cutoff = 250.0000 Ry convergence threshold = 1.0E-06 mixing beta = 0.7000 number of iterations used = 8 plain mixing Exchange-correlation = SLA PZ NOGX NOGC ( 1 1 0 0 0) EXX-fraction = 0.00 celldm(1)= 32.000000 celldm(2)= 0.000000 celldm(3)= 0.830000 celldm(4)= 0.000000 celldm(5)= 0.000000 celldm(6)= 0.000000 crystal axes: (cart. coord. in units of alat) a(1) = ( 1.000000 0.000000 0.000000 ) a(2) = ( 0.000000 1.000000 0.000000 ) a(3) = ( 0.000000 0.000000 0.830000 ) reciprocal axes: (cart. coord. in units 2 pi/alat) b(1) = ( 1.000000 0.000000 0.000000 ) b(2) = ( 0.000000 1.000000 0.000000 ) b(3) = ( 0.000000 0.000000 1.204819 ) PseudoPot. # 1 for C read from file: ../pseudo/C.pz-rrkjus.UPF MD5 check sum: a648be5dbf3fafdfb4e35f5396849845 Pseudo is Ultrasoft, Zval = 4.0 Generated by new atomic code, or converted to UPF format Using radial grid of 1425 points, 4 beta functions with: l(1) = 0 l(2) = 0 l(3) = 1 l(4) = 1 Q(r) pseudized with 0 coefficients PseudoPot. # 2 for H read from file: ../pseudo/H.pz-rrkjus.UPF MD5 check sum: c325bf28c048744aca8614a82587641e Pseudo is Ultrasoft, Zval = 1.0 Generated by new atomic code, or converted to UPF format Using radial grid of 1061 points, 2 beta functions with: l(1) = 0 l(2) = 0 Q(r) pseudized with 0 coefficients atomic species valence mass pseudopotential C 4.00 12.01000 C ( 1.00) H 1.00 1.00000 H ( 1.00) No symmetry found (note: 3 additional sym.ops. were found but ignored their fractional transations are incommensurate with FFT grid) Cartesian axes site n. atom positions (alat units) 1 C tau( 1) = ( 0.3326627 0.3732718 0.2952697 ) 2 C tau( 2) = ( 0.4043454 0.4973890 0.2952697 ) 3 C tau( 3) = ( 0.4760191 0.4560089 0.2952697 ) 4 C tau( 4) = ( 0.4760166 0.3732585 0.2952697 ) 5 C tau( 5) = ( 0.4043364 0.3318871 0.2952697 ) 6 C tau( 6) = ( 0.3326674 0.4560225 0.2952697 ) 7 H tau( 7) = ( 0.4043574 0.5617361 0.2952697 ) 8 H tau( 8) = ( 0.5317432 0.4881776 0.2952697 ) 9 H tau( 9) = ( 0.5317393 0.3410894 0.2952697 ) 10 H tau( 10) = ( 0.4043332 0.2675452 0.2952697 ) 11 H tau( 11) = ( 0.2769368 0.3411096 0.2952697 ) 12 H tau( 12) = ( 0.2769507 0.4882003 0.2952697 ) number of k points= 1 cart. coord. in units 2pi/alat k( 1) = ( 0.0000000 0.0000000 0.0000000), wk = 2.0000000 Dense grid: 907679 G-vectors FFT dimensions: ( 162, 162, 135) Smooth grid: 229587 G-vectors FFT dimensions: ( 108, 108, 90) Largest allocated arrays est. size (Mb) dimensions Kohn-Sham Wavefunctions 1.64 Mb ( 7165, 15) NL pseudopotentials 6.56 Mb ( 7165, 60) Each V/rho on FFT grid 13.62 Mb ( 892296) Each G-vector array 1.73 Mb ( 226920) G-vector shells 0.47 Mb ( 61673) Largest temporary arrays est. size (Mb) dimensions Auxiliary wavefunctions 3.28 Mb ( 7165, 60) Each subspace H/S matrix 0.03 Mb ( 60, 60) Each matrix 0.01 Mb ( 60, 15) Arrays for rho mixing 108.92 Mb ( 892296, 8) Initial potential from superposition of free atoms Check: negative starting charge= -0.002427 starting charge 29.44704, renormalised to 30.00000 negative rho (up, down): 0.247E-02 0.000E+00 Starting wfc are 30 randomized atomic wfcs total cpu time spent up to now is 9.1 secs per-process dynamical memory: 121.8 Mb Self-consistent Calculation iteration # 1 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 1.00E-02, avg # of iterations = 3.0 negative rho (up, down): 0.987E-03 0.000E+00 total cpu time spent up to now is 13.2 secs total energy = -74.98474707 Ry Harris-Foulkes estimate = -76.57596365 Ry estimated scf accuracy < 2.33159919 Ry iteration # 2 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 7.77E-03, avg # of iterations = 2.0 negative rho (up, down): 0.888E-03 0.000E+00 total cpu time spent up to now is 17.1 secs total energy = -75.31263135 Ry Harris-Foulkes estimate = -75.41369450 Ry estimated scf accuracy < 0.18206888 Ry iteration # 3 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 6.07E-04, avg # of iterations = 2.0 negative rho (up, down): 0.765E-03 0.000E+00 total cpu time spent up to now is 20.9 secs total energy = -75.34593467 Ry Harris-Foulkes estimate = -75.35621023 Ry estimated scf accuracy < 0.01711936 Ry iteration # 4 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 5.71E-05, avg # of iterations = 2.0 negative rho (up, down): 0.744E-03 0.000E+00 total cpu time spent up to now is 24.7 secs total energy = -75.35067423 Ry Harris-Foulkes estimate = -75.35064911 Ry estimated scf accuracy < 0.00047685 Ry iteration # 5 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 1.59E-06, avg # of iterations = 3.0 negative rho (up, down): 0.885E-03 0.000E+00 total cpu time spent up to now is 28.7 secs total energy = -75.35082185 Ry Harris-Foulkes estimate = -75.35081935 Ry estimated scf accuracy < 0.00005147 Ry iteration # 6 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 1.72E-07, avg # of iterations = 3.0 negative rho (up, down): 0.990E-03 0.000E+00 total cpu time spent up to now is 32.6 secs total energy = -75.35083505 Ry Harris-Foulkes estimate = -75.35083762 Ry estimated scf accuracy < 0.00000507 Ry iteration # 7 ecut= 25.00 Ry beta=0.70 Davidson diagonalization with overlap ethr = 1.69E-08, avg # of iterations = 3.0 negative rho (up, down): 0.964E-03 0.000E+00 total cpu time spent up to now is 35.8 secs End of self-consistent calculation k = 0.0000 0.0000 0.0000 ( 28664 PWs) bands (ev): -20.9497 -18.1829 -18.1811 -14.6488 -14.6477 -12.8007 -10.9897 -10.8987 -10.1211 -10.1193 -9.0657 -8.1468 -8.1466 -6.3538 -6.3522 ! total energy = -75.35083741 Ry Harris-Foulkes estimate = -75.35083792 Ry estimated scf accuracy < 0.00000050 Ry The total energy is the sum of the following terms: one-electron contribution = -352.08861387 Ry hartree contribution = 178.94643389 Ry xc contribution = -24.64381857 Ry ewald contribution = 122.43516114 Ry convergence has been achieved in 7 iterations Writing output data file benzene.save init_run : 8.78s CPU 8.94s WALL ( 1 calls) electrons : 26.24s CPU 26.72s WALL ( 1 calls) Called by init_run: wfcinit : 0.97s CPU 0.99s WALL ( 1 calls) potinit : 3.45s CPU 3.52s WALL ( 1 calls) realus : 0.95s CPU 0.95s WALL ( 1 calls) Called by electrons: c_bands : 11.24s CPU 11.32s WALL ( 7 calls) sum_band : 6.37s CPU 6.42s WALL ( 7 calls) v_of_rho : 2.39s CPU 2.42s WALL ( 8 calls) newd : 0.11s CPU 0.12s WALL ( 8 calls) mix_rho : 2.55s CPU 2.57s WALL ( 7 calls) Called by c_bands: init_us_2 : 0.14s CPU 0.14s WALL ( 15 calls) regterg : 11.00s CPU 11.08s WALL ( 7 calls) Called by *egterg: h_psi : 11.08s CPU 11.15s WALL ( 26 calls) s_psi : 0.18s CPU 0.19s WALL ( 26 calls) g_psi : 0.07s CPU 0.07s WALL ( 18 calls) rdiaghg : 0.01s CPU 0.02s WALL ( 25 calls) Called by h_psi: add_vuspsi : 0.17s CPU 0.17s WALL ( 26 calls) General routines calbec : 0.25s CPU 0.25s WALL ( 33 calls) fft : 8.27s CPU 8.36s WALL ( 52 calls) ffts : 0.60s CPU 0.60s WALL ( 15 calls) fftw : 10.36s CPU 10.42s WALL ( 418 calls) interpolate : 3.25s CPU 3.31s WALL ( 15 calls) davcio : 0.00s CPU 0.01s WALL ( 7 calls) Parallel routines fft_scatter : 4.17s CPU 4.26s WALL ( 485 calls) PWSCF : 35.50s CPU 36.27s WALL This run was terminated on: 11:55:22 12Jan2012 =------------------------------------------------------------------------------= JOB DONE. =------------------------------------------------------------------------------= TDDFPT/Examples/Benzene/Benzene.pw-in0000644000175000017500000000164012341371500015626 0ustar mbamba&control calculation = 'scf' title = 'TDDFPT benzene test' restart_mode='from_scratch', pseudo_dir = '../pseudo', outdir='./out', prefix='benzene' / &system ibrav = 6, celldm(1) = 32, celldm(3) = 0.83, nat = 12, ntyp = 2, ecutwfc = 25, ecutrho = 250, / &electrons tqr=.true. / ATOMIC_SPECIES C 12.01 C.pz-rrkjus.UPF H 1.0 H.pz-rrkjus.UPF ATOMIC_POSITIONS {Angstrom} C 5.633200899 6.320861303 5. C 6.847051545 8.422621957 5. C 8.060751351 7.721904557 5. C 8.060707879 6.320636665 5. C 6.846898786 5.620067381 5. C 5.633279551 7.722134449 5. H 6.847254360 9.512254789 5. H 9.004364510 8.266639340 5. H 9.004297495 5.775895755 5. H 6.846845929 4.530522778 5. H 4.689556006 5.776237709 5. H 4.689791688 8.267023318 5. K_POINTS {gamma} TDDFPT/Examples/Benzene/Benzene.tddfpt-st-in0000644000175000017500000000013712341371500017111 0ustar mbamba&lr_input prefix="benzene", outdir='./out', / &lr_control itermax=5, ipol=1 / TDDFPT/Examples/Benzene/Benzene.tddfpt-in0000644000175000017500000000023712341371500016466 0ustar mbamba&lr_input prefix="benzene", outdir='./out', restart_step=250, restart=.true. !lr_verbosity=9 / &lr_control itermax=1500, ipol=4 / TDDFPT/Examples/Benzene/Makefile0000644000175000017500000000100112341371500014713 0ustar mbambainclude ../make.sys NAME = Benzene default : all all : check_results check_results: $(NAME).pw-out $(NAME).tddfpt-out $(NAME).tddfpt_pp-out $(check_pw) $(NAME).pw-out $(NAME).pw-ref $(check_tddfpt) $(NAME).tddfpt-out $(NAME).tddfpt-ref small_test: $(NAME).pw-out $(NAME).tddfpt-st-out @$(check_pw) $(NAME).pw-out $(NAME).pw-ref @$(check_tddfpt) $(NAME).tddfpt-st-out $(NAME).tddfpt-st-ref clean : - /bin/rm -rf $(NAME).pw-out $(NAME).tddfpt-out $(NAME).tddfpt_pp-out $(NAME).tddfpt-st-out *.plot out/* TDDFPT/README0000644000175000017500000000467512341371500011013 0ustar mbamba###Time Dependent Density Functional Perturbation Theory (TDDFPT) ------------------------------------------------------------------------------- TD-DFPT developers would be grateful if any scientific work done with TD-DFPT contained a reference to one of the following reference papers: turboTDDFT – A code for the simulation of molecular spectra using the Liouville–Lanczos approach to time-dependent density-functional perturbation theory Original Research Article Author(s): Osman Baris Malcioglu, Ralph Gebauer, Dario Rocca, Stefano Baroni Computer Physics Communications, In Press, Accepted Manuscript, Available online 29 April 2011 Turbo charging time-dependent density-functional theory with Lanczos chains Author(s): Rocca D, Gebauer R, Saad Y, et al. Source: JOURNAL OF CHEMICAL PHYSICS Volume: 128 Issue: 15 Article Number: 154105 Published: APR 21 2008 Ultrasoft pseudopotentials in time-dependent density-functional theory Author(s): Walker B, Gebauer R Source: JOURNAL OF CHEMICAL PHYSICS Volume: 127 Issue: 16 Article Number: 164106 Published: OCT 28 2007 Efficient approach to time-dependent density-functional perturbation theory for optical spectroscopy Author(s): Walker B, Saitta AM, Gebauer R, et al. Source: PHYSICAL REVIEW LETTERS Volume: 96 Issue: 11 Article Number: 113001 Published: MAR 24 2006 ------------------------------------------------------------------------------- Version BETA 5 (05/2011) This module uses subroutines from PW and PH along with the general infrasturcture provided by Quantum Espresso. The directory TDDFPT must reside immediately under the espresso directory for Makefiles to work. Standart compilation: Run "make tddfpt" in espresso directory where TDDFPT is a subdirectory Directory Structure: bin : The tddfpt related binaries src : The source files Doc : The manual Examples : Examples and tests. If you run make under this subdirectory a full test is initiated (requires tddfpt to be compiled first). You can also perform a shorter test by "make small_test". Each example has its own seperate Makefile. Please refer to the README under this subdirectory for further information. tools : Various tools: 1) The postprocessing code for calculating absorption spectrum and polarizabilities. 2) A script to recover reduced liouvillian in a format comprehensible to postprocessing code from the stdout. TDDFPT/src/0000755000175000017500000000000012341371517010716 5ustar mbambaTDDFPT/src/lr_dv_setup.f900000755000175000017500000000652312341371472013575 0ustar mbamba! ! Copyright (C) 2001-2008 Quantum ESPRESSO group ! This file is distributed under the terms of the ! GNU General Public License. See the file `License' ! in the root directory of the present distribution, ! or http://www.gnu.org/copyleft/gpl.txt . ! ! Adapted to TDDFPT by Osman Baris Malcioglu (2009) !----------------------------------------------------------------------- SUBROUTINE lr_dv_setup !----------------------------------------------------------------------- ! ! This subroutine prepares some variable which is needed for derivatives ! 1) Set non linear core correction stuff ! 2) computes dmuxc 3) with GC if needed ! ! USE kinds, ONLY : DP USE ions_base, ONLY : ntyp => nsp USE lsda_mod, ONLY : nspin, lsda USE scf, ONLY : rho, rho_core USE fft_base, ONLY : dfftp USE gvect, ONLY : ngm ! USE atom, ONLY : nlcc USE uspp_param, ONLY : upf USE spin_orb, ONLY : domag !USE lr_variables, ONLY : dmuxc, nlcc_any USE nlcc_ph, ONLY : drc,nlcc_any USE noncollin_module, ONLY : noncolin,nspin_mag USE eqv, ONLY : dmuxc USE funct, ONLY : dmxc, dmxc_spin USE lr_variables, ONLY : lr_verbosity, lr_exx USE io_global, ONLY : stdout USE funct, ONLY : exx_is_active IMPLICIT NONE ! real(DP) :: rhotot, rhoup, rhodw ! total charge ! total up charge ! total down charge ! real(DP) :: auxdmuxc(4,4) ! INTEGER :: nt, ir,is,js ! counter on mesh points ! IF (lr_verbosity > 5) THEN WRITE(stdout,'("")') ENDIF CALL start_clock ('lr_dv_setup') ! ! 1) Set non linear core correction stuff ! nlcc_any = any ( upf(1:ntyp)%nlcc ) !do nt = 1, ntyp ! nlcc_any = nlcc_any.or.nlcc (nt) !enddo nlcc_any = ANY ( upf(1:ntyp)%nlcc ) if (nlcc_any) allocate (drc( ngm, ntyp)) ! ! 2) Computes the derivative of the xc potential ! ! IF ( ( .not. exx_is_active() ) .AND. lr_exx ) THEN ! If exx has been enforced from input but we are not using ! any exact exchange (ie we are using the scissor approximation) ! the derivative of the xc potential is not used. dmuxc(:,:,:) = 0.0_DP ELSE dmuxc(:,:,:) = 0.0_DP IF (lsda) THEN DO ir = 1, dfftp%nnr rhoup = rho%of_r (ir, 1) + 0.5d0 * rho_core (ir) rhodw = rho%of_r (ir, 2) + 0.5d0 * rho_core (ir) CALL dmxc_spin (rhoup, rhodw, dmuxc(ir,1,1), dmuxc(ir,2,1), & dmuxc(ir,1,2), dmuxc(ir,2,2) ) ENDDO ELSE ! IF (noncolin.and.domag) THEN ! do ir = 1, dfftp%nnr ! rhotot = rho%of_r (ir, 1) + rho_core (ir) ! call dmxc_nc (rhotot, rho%of_r(ir,2), rho%of_r(ir,3), rho%of_r(ir,4), auxdmuxc) ! DO is=1,nspin_mag ! DO js=1,nspin_mag ! dmuxc(ir,is,js)=auxdmuxc(is,js) ! END DO ! END DO ! enddo ! ELSE DO ir = 1, dfftp%nnr rhotot = rho%of_r (ir, 1) + rho_core (ir) IF (rhotot.GT.1.d-30) dmuxc (ir, 1, 1) = dmxc (rhotot) IF (rhotot.LT. - 1.d-30) dmuxc (ir, 1, 1) = - dmxc ( - rhotot) ENDDO ! END IF ENDIF ENDIF ! ! 3.1) Setup all gradient correction stuff ! call setup_dgc ! IF (lr_verbosity > 5) WRITE(stdout,'("")') CALL stop_clock ('lr_dv_setup') ! RETURN END SUBROUTINE lr_dv_setup TDDFPT/src/lr_lanczos.f900000755000175000017500000002273212341371472013415 0ustar mbambaMODULE lr_lanczos CONTAINS !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! ! OBM : ! ! This subroutine handles two interleaved non-hermitian chains for x and y at the same time, ! ! in the beginning ! for even steps evc1(:,:,:,1) corresponds to q of y and evc1(:,:,:,2) corresponds to p of x ! for odd steps evc1(:,:,:,1) corresponds to q of x and evc1(:,:,:,2) corresponds to p of y ! ! using the terminology of Lanczos chains by Y.Saad, this is effectively equal to ! altering the A matrix correspondingly for even and odd steps correspondingly. ! This change is controlled by the interaction parameter in lr_apply_liouvillian ! ! For further reference please refer to eq. (32) and (33) in ! Ralph Gebauer, Brent Walker J. Chem. Phys., 127, 164106 (2007) ! ! Modified by Osman Baris Malcioglu (2009) ! Modified by Xiaochuan Ge to introduce Pseudo Hermitian Algorithm (2013) SUBROUTINE one_lanczos_step() ! ! Non-Hermitian Lanczos ! USE io_global, ONLY : ionode, stdout USE kinds, ONLY : dp USE klist, ONLY : nks,xk USE lr_variables, ONLY : n_ipol, ltammd, pseudo_hermitian, itermax,& evc1, evc1_new, sevc1_new, evc1_old, sevc1, & evc0, sevc0, d0psi, & alpha_store, beta_store, gamma_store, zeta_store,& charge_response, size_evc, LR_polarization, LR_iteration,&!,real_space test_case_no USE uspp, ONLY : vkb, nkb, okvan USE wvfct, ONLY : nbnd, npwx, npw USE control_flags, ONLY : gamma_only,tqr USE becmod, ONLY : bec_type, becp, calbec !use real_beta, only : ccalbecr_gamma,s_psir,fft_orbital_gamma,bfft_orbital_gamma USE realus, ONLY : real_space, fft_orbital_gamma, initialisation_level, & bfft_orbital_gamma, calbec_rs_gamma, add_vuspsir_gamma, & v_loc_psir, s_psir_gamma, igk_k,npw_k, real_space_debug USE lr_variables, ONLY : lr_verbosity USE charg_resp, ONLY : w_T_beta_store,w_T,lr_calc_F use lr_us, only : lr_apply_s !Debugging USE lr_variables, ONLY: check_all_bands_gamma, check_density_gamma,check_vector_gamma ! IMPLICIT NONE ! COMPLEX(kind=dp),EXTERNAL :: lr_dot ! !integer,intent(in) :: iter, pol INTEGER :: ik, ip, ibnd,ig, pol_index ! CHARACTER(len=6), EXTERNAL :: int_to_char ! ! Local variables ! real(kind=dp) :: alpha, beta, gamma, angle ! COMPLEX(kind=dp) :: zeta ! !integer :: n ! ! IF (lr_verbosity > 5) THEN WRITE(stdout,'("")') ENDIF IF (lr_verbosity > 10) THEN PRINT *, "Real space = ", real_space PRINT *, "Real space debug ", real_space_debug PRINT *, "TQR = ", tqr ENDIF ! CALL start_clock('one_step') pol_index=1 IF ( n_ipol /= 1 ) pol_index=LR_polarization ! Apply Liouvillian if(.not. ltammd) then if(mod(LR_iteration,2)==0) then CALL lr_apply_liouvillian(evc1(1,1,1,1),evc1_new(1,1,1,1),sevc1_new(1,1,1,1),.true.) if(.not. pseudo_hermitian) & CALL lr_apply_liouvillian(evc1(1,1,1,2),evc1_new(1,1,1,2),sevc1_new(1,1,1,2),.false.) ELSE CALL lr_apply_liouvillian(evc1(1,1,1,1),evc1_new(1,1,1,1),sevc1_new(1,1,1,1),.false.) if(.not. pseudo_hermitian) & CALL lr_apply_liouvillian(evc1(1,1,1,2),evc1_new(1,1,1,2),sevc1_new(1,1,1,2),.true.) ENDIF ELSE CALL lr_apply_liouvillian(evc1(1,1,1,1),evc1_new(1,1,1,1),sevc1_new(1,1,1,1),.true.) if(.not. pseudo_hermitian) then CALL zcopy(size_evc,evc1(1,1,1,1),1,evc1(1,1,1,2),1) !evc1(,1) = evc1(,2) CALL zcopy(size_evc,evc1_new(1,1,1,1),1,evc1_new(1,1,1,2),1) !evc1_new(,1) = evc1_new(,2) endif ENDIF DO ik=1, nks CALL lr_ortho(evc1_new(:,:,ik,1), evc0(:,:,ik), ik, ik, sevc0(:,:,ik),.true.) if(.not. pseudo_hermitian) & CALL lr_ortho(evc1_new(:,:,ik,2), evc0(:,:,ik), ik, ik, sevc0(:,:,ik),.true.) ENDDO ! By construction =0 should be 0, forcing this both conserves resources and increases stability alpha=0.0d0 alpha_store(pol_index,LR_iteration)=alpha WRITE(stdout,'(5X,"alpha(",i8.8,")=",e22.15)') LR_iteration,alpha ! Apply S* operation if(pseudo_hermitian) then call lr_apply_s(evc1_new(:,:,1,1),sevc1_new(:,:,1,1)) else call lr_apply_s(evc1(:,:,1,2),sevc1(:,:,1,2)) endif ! Orthogonality requirement: =1 if(pseudo_hermitian) then beta=dble(lr_dot(evc1(1,1,1,1),sevc1_new(1,1,1,1))) else beta=dble(lr_dot(evc1(1,1,1,1),sevc1(1,1,1,2))) !call lr_apply_s(evc1(:,:,1,1),sevc1(:,:,1,1)) !angle=dble(lr_dot(evc1(1,1,1,1),sevc1(1,1,1,1)))*dble(lr_dot(evc1(1,1,1,2),sevc1(1,1,1,2))) !angle=beta/sqrt(angle) !angle = acos(angle) !print *, "Pol: ", LR_polarization, "Iteration: ",LR_iteration, "Angle:", angle endif ! Beta is less than 0 is a serious error for pseudo hermitian algorithm if( beta < 0.0d0 .and. pseudo_hermitian) call error_beta() IF ( abs(beta)<1.0d-12 ) WRITE(stdout,'(5x,"lr_lanczos: Left and right Lanczos vectors are orthogonal,& &this is a violation of oblique projection")') IF ( beta<0.0d0 ) THEN beta=sqrt(-beta) gamma=-beta ELSEIF ( beta>0.0d0 ) THEN ! Actually this is the only case in pseudo hermitian algorithm beta=sqrt(beta) gamma=beta ENDIF beta_store (pol_index,LR_iteration) = beta gamma_store(pol_index,LR_iteration) = gamma WRITE(stdout,'(5X,"beta (",i8.8,")=",e22.15)') LR_iteration,beta WRITE(stdout,'(5X,"gamma(",i8.8,")=",e22.15)') LR_iteration,gamma ! renormalize q(i) and Lq(i), also p(i) and Lp(i) in non pseudo hermitian case CALL zscal(size_evc,cmplx(1.0d0/beta,0.0d0,kind=dp),evc1(1,1,1,1),1) CALL zscal(size_evc,cmplx(1.0d0/beta,0.0d0,kind=dp),evc1_new(1,1,1,1),1) if(.not. pseudo_hermitian) then CALL zscal(size_evc,cmplx(1.0d0/gamma,0.0d0,kind=dp),evc1(1,1,1,2),1) CALL zscal(size_evc,cmplx(1.0d0/gamma,0.0d0,kind=dp),evc1_new(1,1,1,2),1) endif ! Calculation of zeta coefficients if (mod(LR_iteration,2)==0) then do ip=1,n_ipol zeta = lr_dot(d0psi(:,:,:,ip),evc1(:,:,:,1)) !Why gamma point dot? zeta_store (pol_index,ip,LR_iteration) = zeta write(stdout,'(5x,"z1= ",1x,i6,2(1x,e22.15))') ip,real(zeta),aimag(zeta) enddo IF (charge_response == 1) THEN CALL lr_calc_dens(evc1(:,:,:,1), .true.) CALL lr_calc_F(evc1(:,:,:,1)) ENDIF else do ip = 1, n_ipol zeta = (0.0d0,0.0d0) zeta_store (pol_index,ip,LR_iteration) = zeta write(stdout,'(5x,"z1= ",1x,i6,2(1x,e22.15))') ip,real(zeta),aimag(zeta) enddo endif ! XC. Ge : q(i+1)=Lq(i)-beta(i)*q(i-1); renormalization will be done in the ! begining of the next iteration ! In non pseudo hermitian case, similar operation needs to be done also for p(i) CALL zaxpy(size_evc,-cmplx(gamma,0.0d0,kind=dp),evc1_old(1,1,1,1),1,evc1_new(1,1,1,1),1) if(.not. pseudo_hermitian) & CALL zaxpy(size_evc,-cmplx(beta,0.0d0,kind=dp),evc1_old(1,1,1,2),1,evc1_new(1,1,1,2),1) ! To increase stability, apply lr_ortho once more DO ik=1, nks CALL lr_ortho(evc1_new(:,:,ik,1), evc0(:,:,ik), ik, ik, sevc0(:,:,ik),.true.) if(.not. pseudo_hermitian) & CALL lr_ortho(evc1_new(:,:,ik,2), evc0(:,:,ik), ik, ik, sevc0(:,:,ik),.true.) ENDDO ! XC. Ge : throw away q(i-1), and make q(i+1) to be the current vector, ! be ready for the next iteration. evc1_new will be free again after this step CALL zcopy(size_evc,evc1(1,1,1,1),1,evc1_old(1,1,1,1),1) !evc1_old = evc1 CALL zcopy(size_evc,evc1_new(1,1,1,1),1,evc1(1,1,1,1),1) !evc1 = evc1_new if(.not. pseudo_hermitian) then CALL zcopy(size_evc,evc1(1,1,1,2),1,evc1_old(1,1,1,2),1) !evc1_old = evc1 CALL zcopy(size_evc,evc1_new(1,1,1,2),1,evc1(1,1,1,2),1) !evc1 = evc1_new endif IF (ionode) THEN IF ( charge_response == 1 .and. lr_verbosity > 0) THEN !print *, "beta=",beta,"w_T_beta_store", w_T_beta_store(LR_iteration) WRITE (stdout,'(5x,"(calc=",e22.15," read=",e22.15,")")') beta, w_T_beta_store(LR_iteration) WRITE (stdout,'(5x,"Weight for this step=",2(e12.5,1x))') w_T(LR_iteration) ENDIF ENDIF CALL stop_clock('one_step') RETURN !---------------------------------------------------------------------------------------------- contains subroutine error_beta() implicit none integer :: ib,ik WRITE(stdout,'(5x,"Error: Beta is negative:",5x,e22.15)') beta do ib = 1, nbnd do ik = 1, npwx write(301,*) ib,ik,dble(evc1(ik,ib,1,1)),aimag(evc1(ik,ib,1,1)) enddo enddo close(301) do ib = 1, nbnd do ik = 1, npwx write(302,*) ib,ik,dble(evc1(ik,ib,1,2)),aimag(evc1(ik,ib,1,2)) enddo enddo close(302) do ib = 1, nbnd do ik = 1, npwx write(303,*) ib,ik,dble(sevc1_new(ik,ib,1,2)),aimag(evc1(ik,ib,1,2)) enddo enddo close(303) stop "Beta is negative" end subroutine error_beta END SUBROUTINE one_lanczos_step !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! END MODULE lr_lanczos TDDFPT/src/lr_set_boxes_density.f900000755000175000017500000000316412341371472015474 0ustar mbamba!----------------------------------------------------------------------- !OBM ! 150608 pfft replaced by fft_base :: dfftp SUBROUTINE lr_set_boxes_density() !--------------------------------------------------------------------- ! ... set boxes for the calculation of density response !--------------------------------------------------------------------- ! ! Modified by Osman Baris Malcioglu (2009) ! USE io_global, ONLY : stdout USE kinds, ONLY : dp USE lr_variables, ONLY : cube_save !use pfft, only : npp USE fft_base, ONLY : dfftp USE mp_global, ONLY : me_pool USE lr_variables, ONLY : lr_verbosity ! IMPLICIT NONE ! INTEGER :: index0, index, ir INTEGER :: i, j, k, p, nr ! IF (lr_verbosity > 5) THEN WRITE(stdout,'("")') ENDIF CALL start_clock( 'lr_set_boxes' ) ! ALLOCATE( cube_save( dfftp%nnr, 3 ) ) cube_save = 0 ! index0 = 0 ! #if defined (__MPI) ! DO i = 1, me_pool index0 = index0 + dfftp%nr1x*dfftp%nr2x*dfftp%npp(i) ENDDO ! #endif ! DO ir = 1, dfftp%nnr ! ! ... three dimensional indexes ! index = index0 + ir - 1 k = index / (dfftp%nr1x*dfftp%nr2x) index = index - (dfftp%nr1x*dfftp%nr2x)*k j = index / dfftp%nr1x index = index - dfftp%nr1x*j i = index ! IF ( i>=dfftp%nr1 .or. j>=dfftp%nr2 .or. k>=dfftp%nr3 ) CYCLE ! cube_save(ir,1) = i cube_save(ir,2) = j cube_save(ir,3) = k ! ENDDO ! CALL stop_clock( 'lr_set_boxes' ) ! END SUBROUTINE lr_set_boxes_density TDDFPT/src/lr_readin.f900000755000175000017500000004253312341371472013207 0ustar mbamba! ! Copyright (C) 2001-2011 Quantum ESPRESSO group ! This file is distributed under the terms of the ! GNU General Public License. See the file `License' ! in the root directory of the present distribution, ! or http://www.gnu.org/copyleft/gpl.txt . ! !---------------------------------------------------------------------------- SUBROUTINE lr_readin !----------------------------------------------------------------------- ! ! This routine reads the control variables from standard input (unit 5). ! A second routine read_file reads the variables saved to file ! by the self-consistent program. ! USE lr_variables USE lr_dav_variables USE kinds, ONLY : DP USE io_files, ONLY : tmp_dir, prefix, wfc_dir USE lsda_mod, ONLY : current_spin, nspin USE control_flags, ONLY : twfcollect,use_para_diag USE scf, ONLY : vltot, v, vrs, vnew, rho, & & destroy_scf_type USE fft_base, ONLY : dfftp USE gvecs, ONLY : doublegrid USE wvfct, ONLY : nbnd, et, wg, current_k USE lsda_mod, ONLY : isk USE ener, ONLY : ef USE io_global, ONLY : ionode, ionode_id USE klist, ONLY : nks, wk, nelec USE fixed_occ, ONLY : tfixed_occ USE input_parameters, ONLY : degauss, nosym, wfcdir, outdir,& & max_seconds USE ktetra, ONLY : ltetra USE realus, ONLY : real_space, real_space_debug,& & init_realspace_vars, qpointlist,& & betapointlist, newd_r USE funct, ONLY : dft_is_meta USE io_global, ONLY : stdout USE control_flags, ONLY : tqr, twfcollect, ethr USE iotk_module USE charg_resp, ONLY : w_T_prefix, omeg, w_T_npol, epsil USE mp, ONLY : mp_bcast USE mp_world, ONLY : world_comm USE mp_global, ONLY : my_pool_id, intra_image_comm, & & intra_bgrp_comm, nproc_image, & & nproc_pool, nproc_pool_file, & & nproc_image_file, nproc_bgrp, & & nproc_bgrp_file USE io_global, ONLY : ionode, ionode_id USE DFUNCT, ONLY : newd USE vlocal, ONLY : strf USE exx, ONLY : ecutfock #ifdef __ENVIRON USE input_parameters, ONLY : assume_isolated USE environ_base, ONLY : environ_base_init, ir_end USE environ_input, ONLY : read_environ USE environ_base, ONLY : ifdtype, nfdpoint USE ions_base, ONLY : nsp, ityp, zv, tau, nat USE cell_base, ONLY : at, alat, omega, ibrav USE solvent_tddfpt, ONLY : solvent_initbase_tddfpt USE environ_init, ONLY : environ_initions, environ_initcell, & environ_clean, environ_initbase, & environ_initions_allocate USE environ_main, ONLY : calc_venviron USE mp_bands, ONLY : me_bgrp USE plugin_flags, ONLY : use_environ #endif IMPLICIT NONE ! CHARACTER(LEN=256), EXTERNAL :: trimcheck ! CHARACTER(LEN=256) :: beta_gamma_z_prefix ! fine control of beta_gamma_z file CHARACTER(LEN=80) :: disk_io ! Specify the amount of I/O activities INTEGER :: ios, iunout, ierr, ipol LOGICAL :: auto_rs REAL(kind=dp) :: charge ! NAMELIST / lr_input / restart, restart_step ,lr_verbosity, prefix, outdir, test_case_no, wfcdir, disk_io, max_seconds NAMELIST / lr_control / itermax, ipol, ltammd, real_space, real_space_debug, charge_response, tqr, auto_rs, no_hxc, n_ipol, & & project, scissor, ecutfock, pseudo_hermitian,d0psi_rs NAMELIST / lr_post / omeg, beta_gamma_z_prefix, w_T_npol, plot_type, epsil, itermax_int namelist / lr_dav / num_eign, num_init, num_basis_max, residue_conv_thr, precondition,dav_debug, reference,single_pole,& &sort_contr, diag_of_h, close_pre,broadening,print_spectrum,start,finish,step,if_check_orth,& &if_random_init,if_check_her,p_nbnd_occ,p_nbnd_virt,poor_of_ram,poor_of_ram2,max_iter,ecutfock,& &conv_assistant,if_dft_spectrum,no_hxc,d0psi_rs ! auto_rs = .TRUE. #ifdef __MPI IF (ionode) THEN #endif ! ! Set default values for variables in namelist ! CALL get_env( 'ESPRESSO_TMPDIR', outdir ) IF ( trim( outdir ) == ' ' ) outdir = './' itermax = 500 restart = .FALSE. restart_step = itermax+1 lr_verbosity = 1 prefix = 'pwscf' disk_io = 'default' ltammd = .FALSE. d0psi_rs=.false. pseudo_hermitian=.true. ipol = 1 n_ipol = 1 no_hxc = .FALSE. real_space = .FALSE. real_space_debug = 0 charge_response = 0 test_case_no = 0 tqr = .FALSE. auto_rs = .TRUE. beta_gamma_z_prefix = 'undefined' omeg= 0.0_DP epsil = 0.0_DP w_T_npol = 1 plot_type = 1 project = .FALSE. max_seconds = 0.D0 eig_dir='./' scissor = 0.d0 ecutfock = -1d0 ! For lr_dav num_eign=1 num_init=2 num_basis_max=20 broadening=0.005 residue_conv_thr=1.0E-4 close_pre=1.0E-5 turn2planb=1.0E-3 precondition=.true. dav_debug=.false. reference=0 single_pole=.false. sort_contr=.true. print_spectrum=.true. start=0.0d0 finish=1.0d0 step=0.001d0 if_check_orth=.false. if_check_her=.false. if_random_init=.false. p_nbnd_occ=10 p_nbnd_virt=10 poor_of_ram=.false. poor_of_ram2=.false. max_iter=100 conv_assistant=.false. if_dft_spectrum=.false. ! ! ------------------------------------------------------ ! Reading possible plugin arguments -environ -plumed ... ! ------------------------------------------------------ CALL plugin_arguments() ! ------------------------------------------------------ ! ! Reading the namelist lr_input CALL input_from_file( ) ! READ (5, lr_input, err = 200, iostat = ios) 200 CALL errore ('lr_readin', 'reading lr_input namelist', ABS (ios) ) ! ! ! Reading the namelist lr_control if(.not. davidson) then READ (5, lr_control, err = 201, iostat = ios) 201 CALL errore ('lr_readin', 'reading lr_control namelist', ABS (ios) ) endif if(davidson) then READ (5, lr_dav, err = 299, iostat = ios) 299 CALL errore ('lr_readin', 'reading lr_dav namelist', ABS (ios) ) endif ! ! ! Reading the namelist lr_post IF (charge_response == 1) THEN READ (5, lr_post, err = 202, iostat = ios) 202 CALL errore ('lr_readin', 'reading lr_post namelist', ABS (ios) ) bgz_suffix = TRIM ( "-stage2.beta_gamma_z." ) WRITE(stdout,'(/5x,"Prefix of current run is appended by -stage2")') IF ( beta_gamma_z_prefix == 'undefined' ) THEN beta_gamma_z_prefix=TRIM(prefix) ENDIF ELSE bgz_suffix = TRIM ( ".beta_gamma_z." ) ENDIF ! ! The status of the real space flags should be read manually ! ! Do not mess with already present wfc structure twfcollect = .FALSE. ! ! Set-up all the dir and suffix variables. ! outdir = trimcheck(outdir) tmp_dir = outdir w_T_prefix = TRIM( tmp_dir ) // TRIM( beta_gamma_z_prefix ) // & & ".beta_gamma_z." ! ierr = 0 ! ! Set-up polarization direction(s). ! IF ( ipol==4 ) THEN ! n_ipol = 3 LR_polarization=1 ! ELSE ! LR_polarization=ipol ! ENDIF IF (itermax_int < itermax) itermax_int=itermax ! ! Limited disk_io support: currently only one setting is supported ! SELECT CASE( TRIM( disk_io ) ) CASE ( 'reduced' ) ! lr_io_level = -1 restart = .FALSE. ! CASE DEFAULT ! lr_io_level = 1 END SELECT #ifdef __MPI ENDIF ! CALL bcast_lr_input CALL mp_bcast(auto_rs, ionode_id, world_comm) #endif ! current_k = 1 ! Required for restart runs as this never gets initalised outdir = TRIM( tmp_dir ) // TRIM( prefix ) // '.save' IF (auto_rs) CALL read_rs_status( outdir, tqr, real_space, ierr ) IF (real_space) real_space_debug=99 IF (real_space_debug > 0) real_space=.TRUE. IF (lr_verbosity > 1) THEN WRITE(stdout,'(5x,"Status of real space flags: TQR=", L5 ,& &" REAL_SPACE=", L5)') tqr, real_space ENDIF ! ! Now PWSCF XML file will be read, and various initialisations will be done ! CALL read_file() ! ! Copy data read from input file (in subroutine "read_input_file") and ! stored in modules input_parameters into internal modules of Environ module ! #ifdef __ENVIRON ! IF ( use_environ ) THEN ! !!!!!!!!!!!!!!!!!!!!!!!!!!! Initialisation !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! ! ! Copied from PW/src/input.f90 ! Note: in the routine "environ_base_init" the variable use_environ (from ! environ_base) is defined according to use_environ (from input_parameters). ! In the Environ code the variable use_environ (from environ_base) is used. ! ! Warning: There is something strange with the variable 'assume_isolated'! ! It is not used currently. ! CALL read_environ( nat, nsp, assume_isolated, ibrav ) ! ! Taken from PW/src/init_run.f90 ! ir_end = MIN(dfftp%nnr,dfftp%nr1x*dfftp%nr2x*dfftp%npp(me_bgrp+1)) CALL environ_initbase( dfftp%nnr ) ! ! Taken from PW/src/electrons.f90 ! CALL environ_initions( dfftp%nnr, nat, nsp, ityp, zv, tau, alat ) CALL environ_initcell( dfftp%nnr, dfftp%nr1, dfftp%nr2, dfftp%nr3, ibrav, omega, alat, at ) ! ! Compute additional unperturbed potentials due to the presence of the environment ! and add them to the SCF (HXC) potential. ! WRITE( stdout, '(/5x,"Computing and adding the polarization potentials to HXC potential")' ) ! CALL calc_venviron( .TRUE., dfftp%nnr, nspin, 0.0d0, rho%of_r, v%of_r(:,1)) ! ! Now, once the Environ potentials were computed we can deallocate numerous ! Environ arrays because they are not needed any longer. ! CALL environ_clean( .TRUE. ) ! ! Allocations for TDDFPT ! CALL solvent_initbase_tddfpt(ifdtype, nfdpoint, dfftp%nnr) ! ENDIF ! #endif ! ! Set wfc_dir - this is done here because read_file sets wfc_dir = tmp_dir ! FIXME:,if wfcdir is not present in input, wfc_dir is set to "undefined" ! instead of tmp_dir, because of the logic used in the rest of TDDFPT ! wfc_dir = trimcheck ( wfcdir ) ! ! Make sure all the features used in the PWscf calculation are actually ! supported by TDDFPT. ! CALL input_sanity() ! ! Deallocate some variables created with read_file but not used in TDDFPT ! DEALLOCATE( strf ) CALL destroy_scf_type(vnew) ! ! Re-initialize all needed quantities from the scf run ! current_spin=1 ! CALL init_us_1 ( ) ! IF (tqr) THEN CALL newd_r() ELSE CALL newd() !OBM: this is for the ground charge density ENDIF ! IF ( real_space_debug > 0 ) THEN WRITE(stdout,'(/5x,"Real space implementation V.1 D190908",1x)') ! !OBM - correct parellism issues CALL init_realspace_vars() CALL betapointlist() WRITE(stdout,'(5X,"Real space initialisation completed")') ENDIF ! ! Now put the potential calculated in read_file into the correct place ! and deallocate the now redundant associated variables ! CALL set_vrs ( vrs, vltot, v%of_r, 0, 0, dfftp%nnr, nspin, doublegrid ) DEALLOCATE( vltot ) CALL destroy_scf_type(v) ! ! Recalculate the weights of the Kohn-Sham orbitals. ! (Should this not be a call to weights() to make this !#! ! less insulator specific?) !#! ! CALL iweights( nks, wk, nbnd, nelec, et, ef, wg, 0, isk) ! IF ( charge_response == 2 ) CALL lr_set_boxes_density() ! ! Checking ! ! !Scalapack related stuff, ! #ifdef __MPI use_para_diag = .TRUE. CALL check_para_diag( nbnd ) #else use_para_diag = .FALSE. #endif RETURN CONTAINS SUBROUTINE input_sanity() !-------------------------------------------------------------------------- ! ! This routine aims to gather together all of the input sanity checks ! (features enabled in PWscf which are unsupported in TDDFPT) together in ! one place. ! !-------------------------------------------------------------------------- USE fft_base, ONLY : dffts USE paw_variables, ONLY : okpaw USE uspp, ONLY : okvan USE funct, ONLY : dft_is_hybrid IMPLICIT NONE ! ! Charge response mode 1 is the "do Lanczos chains twice, conserve memory" ! scheme ! IF (charge_response == 1 .AND. omeg == 0.D0) & & CALL errore ('lr_readin', & & 'omeg must be defined for charge response mode 1', 1 ) IF ( project .AND. charge_response /= 1) & & CALL errore ('lr_readin', & & 'projection is possible only in charge response mode 1', 1 ) ! ! Meta-DFT currently not supported by TDDFPT ! IF (dft_is_meta()) & & CALL errore( ' iosys ', ' Meta DFT ' // 'not implemented yet', 1 ) ! ! Non-insulating systems currently not supported by TDDFPT ! IF ( (ltetra .OR. tfixed_occ .OR. (degauss /= 0.D0)) ) & & CALL errore( ' iosys ', ' Linear response calculation ' // & & 'not implemented for non-insulating systems', 1 ) ! ! Symmetry not supported ! IF ( .NOT. nosym ) & & CALL errore( ' iosys ', ' Linear response calculation ' // & & 'not implemented with symmetry', 1 ) ! ! K-points implemented but still unsupported (use at your own risk!) ! IF ( .NOT. gamma_only ) & & CALL errore(' iosys', 'k-point algorithm is not tested yet',1) ! ! Check that either we have the same numebr of procs as the inital PWscf ! run OR that the wavefunctions were gathered into one file at the end of ! the PWscf run. ! IF (nproc_image /= nproc_image_file .AND. .NOT. twfcollect) & CALL errore('lr_readin',& & 'pw.x run with a different number of processors. & & Use wf_collect=.true.',1) IF (nproc_pool /= nproc_pool_file .AND. .NOT. twfcollect) & CALL errore('lr_readin',& & 'pw.x run with a different number of pools. & & Use wf_collect=.true.',1) IF (nproc_bgrp /= nproc_bgrp_file .AND. .NOT. twfcollect) & CALL errore('lr_readin',& & 'pw.x run with a different number of band groups. & & Use wf_collect=.true.',1) ! ! No taskgroups and EXX. ! IF (dffts%have_task_groups .AND. dft_is_hybrid()) & & CALL errore( ' iosys ', ' Linear response calculation ' // & & 'not implemented for EXX+Task groups', 1 ) ! ! Experimental task groups warning. ! IF (dffts%have_task_groups) CALL infomsg( 'lr_readin','Usage of task & &groups with TDDFPT is still experimental. Use at your own risk.' ) ! ! No PAW support. ! IF (okpaw) & & CALL errore( ' iosys ', ' Linear response calculation ' // & & 'not implemented for PAW', 1 ) ! ! No USPP+EXX support. ! IF (okvan .AND. dft_is_hybrid()) & & CALL errore( ' iosys ', ' Linear response calculation ' // & & 'not implemented for EXX+Ultrasoft', 1 ) ! RETURN ! END SUBROUTINE input_sanity ! !------------------------------------------------------------------------ SUBROUTINE read_rs_status( dirname, tqr, real_space, ierr ) !------------------------------------------------------------------------ ! ! This subroutine reads the real space control flags from a pwscf punch card ! OBM 2009 - FIXME: should be moved to qexml.f90 ! USE iotk_module USE io_global, ONLY : ionode,ionode_id USE io_files, ONLY : iunpun, xmlpun USE mp, ONLY : mp_bcast USE mp_images, ONLY : intra_image_comm ! IMPLICIT NONE ! CHARACTER(len=*), INTENT(in) :: dirname LOGICAL, INTENT(out) :: tqr, real_space INTEGER, INTENT(out) :: ierr ! ! IF ( ionode ) THEN ! ! ... look for an empty unit ! CALL iotk_free_unit( iunpun, ierr ) ! CALL errore( 'realus->read_rs_status', 'no free units to read real space flags', ierr ) ! CALL iotk_open_read( iunpun, FILE = trim( dirname ) // '/' // & & trim( xmlpun ), IERR = ierr ) ! ENDIF ! CALL mp_bcast( ierr, ionode_id, intra_image_comm ) ! IF ( ierr > 0 ) RETURN ! IF ( ionode ) THEN CALL iotk_scan_begin( iunpun, "CONTROL" ) ! CALL iotk_scan_dat( iunpun, "Q_REAL_SPACE", tqr ) CALL iotk_scan_dat( iunpun, "BETA_REAL_SPACE", real_space ) ! CALL iotk_scan_end( iunpun, "CONTROL" ) ! CALL iotk_close_read( iunpun ) ENDIF CALL mp_bcast( tqr, ionode_id, intra_image_comm ) CALL mp_bcast( real_space, ionode_id, intra_image_comm ) ! RETURN ! END SUBROUTINE read_rs_status END SUBROUTINE lr_readin TDDFPT/src/lr_dav_main.f900000755000175000017500000001360312341371472013517 0ustar mbamba! ! Copyright (C) 2004-2013 Quantum ESPRESSO group ! This file is distributed under the terms of the ! GNU General Public License. See the file `License' ! in the root directory of the present distribution, ! or http://www.gnu.org/copyleft/gpl.txt . ! !-------------------------------------------------------------------- PROGRAM lr_dav_main !--------------------------------------------------------------------- ! Xiaochuan Ge, SISSA, 2013 !--------------------------------------------------------------------- ! ... overall driver routine for applying davidson algorithm ! ... to the matrix of equations coming from tddft !--------------------------------------------------------------------- USE io_global, ONLY : stdout USE kinds, ONLY : dp USE lr_variables, ONLY : restart, restart_step,& evc1,n_ipol, d0psi, & no_hxc, nbnd_total, & revc0, lr_io_level, code,davidson USE io_files, ONLY : nd_nmbr USE global_version, ONLY : version_number USE ions_base, ONLY : tau,nat,atm,ityp USE environment, ONLY: environment_start USE mp_global, ONLY : nimage, mp_startup, init_index_over_band, inter_bgrp_comm USE wvfct, ONLY : nbnd USE wavefunctions_module, ONLY : psic USE control_flags, ONLY : tddfpt USE check_stop, ONLY : check_stop_now, check_stop_init USE funct, ONLY : dft_is_hybrid use lr_dav_routines use lr_dav_variables use lr_dav_debug !Debugging USE lr_variables, ONLY: check_all_bands_gamma, check_density_gamma,check_vector_gamma ! IMPLICIT NONE INTEGER :: ibnd_occ,ibnd_virt,ibnd,ip LOGICAL :: rflag, nomsg complex(dp) :: temp #ifdef __MPI CALL mp_startup ( ) #endif tddfpt=.TRUE. !Let the phonon routines know that they are doing tddfpt. davidson=.true. ! To tell the code that we are using davidson method CALL environment_start ( code ) CALL start_clock('lr_dav_main') ! Reading input file and PWSCF xml, some initialisation CALL lr_readin ( ) CALL check_stop_init() CALL lr_init_nfo() !Initialisation of degauss/openshell related stuff n_ipol = 3 ! Davidson automaticly calculates all three polarizations CALL lr_alloc_init() ! Allocate and zero lr variables ! Now print some preamble info about the run to stdout CALL lr_print_preamble() ! Read in ground state wavefunctions CALL lr_read_wf() ! CALL init_index_over_band(inter_bgrp_comm,nbnd) ! Set up initial response orbitals CALL lr_solve_e() DEALLOCATE( psic ) if( if_dft_spectrum) call dft_spectrum() ! If we just want to calculate the dft_spectrum ! it is actually not necessary to do Davidson ! iteration call lr_dav_alloc_init() ! allocate for davidson algorithm CALL lr_dav_set_init() ! Set up initial stuff for derivatives CALL lr_dv_setup() ! Davidson loop if (precondition) write(stdout,'(/5x,"Precondition is used in the algorithm,")') do while (.not. dav_conv .and. dav_iter .lt. max_iter) dav_iter=dav_iter+1 if(if_check_orth) call check_orth() ! In one david step, M_C,M_D and M_CD are first constructed;then will be ! solved rigorously; then the solution in the subspace left_sub() will ! be transformed into full space left_full() call one_dav_step() call dav_calc_residue() call dav_expan_basis() enddo ! call check_hermitian() ! Extract physical meaning from the solution call interpret_eign('END') ! The check_orth at the end may take quite a lot of time in the case of ! USPP because we didn't store the S* vector basis. Turn this step on only ! in cases of debugging ! call check_orth() ! Deallocate pw variables CALL clean_pw( .false. ) WRITE(stdout,'(5x,"Finished linear response calculation...")') CALL stop_clock('lr_dav_main') CALL print_clock_lr() CALL stop_lr( .false. ) !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! !Additional small-time subroutines !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! CONTAINS SUBROUTINE lr_print_preamble() USE lr_variables, ONLY : no_hxc, itermax USE uspp, ONLY : okvan USE funct, only : dft_is_hybrid IMPLICIT NONE ! WRITE( stdout, '(/5x,"----------------------------------------")' ) ! WRITE( stdout, '(/5x,"")' ) ! WRITE( stdout, '(/5x,"Please cite this project as: ")' ) ! WRITE( stdout, '(/5x,"O.B. Malcioglu, R. Gebauer, D. Rocca, S. Baroni,")' ) ! WRITE( stdout, '(/5x,"""turboTDDFT – a code for the simulation of molecular")' ) ! WRITE( stdout, '(/5x,"spectra using the Liouville-Lanczos approach to")' ) ! WRITE( stdout, '(/5x,"time-dependent density-functional perturbation theory""")' ) ! WRITE( stdout, '(/5x,"CPC, 182, 1744 (2011)")' ) ! WRITE( stdout, '(/5x,"----------------------------------------")' ) ! WRITE( stdout, '(/5x,"----------------------------------------")' ) WRITE( stdout, '(/5x,"Welcome using turbo-davidson. For this moment you can report bugs to",/5x, & & "Xiaochuan Ge: xiaochuan.ge@sissa.it",/5x, & & "We appreciate a lot your help to make us improve.")' ) WRITE( stdout, '(/5x,"----------------------------------------",/)' ) IF(okvan) WRITE( stdout, '(/5x,"Ultrasoft (Vanderbilt) Pseudopotentials")' ) IF (no_hxc) THEN WRITE(stdout,'(5x,"No Hartree/Exchange/Correlation")') ELSEIF (dft_is_hybrid()) THEN WRITE(stdout, '(/5x,"Use of exact-exchange enabled. Note the EXX correction to the [H,X]", & &/5x,"commutator is NOT included hence the f-sum rule will be violated.")') ENDIF END SUBROUTINE lr_print_preamble END PROGRAM lr_dav_main !----------------------------------------------------------------------- TDDFPT/src/lr_dealloc.f900000755000175000017500000000667512341371472013357 0ustar mbamba! ! Copyright (C) 2004-2013 Quantum ESPRESSO group ! This file is distributed under the terms of the ! GNU General Public License. See the file `License' ! in the root directory of the present distribution, ! or http://www.gnu.org/copyleft/gpl.txt . ! !-------------------------------------------------------------------- SUBROUTINE lr_dealloc() !--------------------------------------------------------------------- ! ... deallocates all the Lanczos variables !--------------------------------------------------------------------- ! ! Modified by Osman Baris Malcioglu (2009) ! USE lr_variables USE uspp, ONLY : nkb USE control_flags, ONLY : gamma_only USE realus, ONLY : igk_k,npw_k USE io_global, ONLY : stdout USE charg_resp, ONLY : w_T_beta_store, w_T_gamma_store, w_T,& & w_T_zeta_store, chi, rho_1_tot, rho_1_tot_im USE eqv, ONLY : dmuxc USE lr_exx_kernel, ONLY : lr_exx_dealloc IMPLICIT NONE ! IF (lr_verbosity > 5) THEN WRITE(stdout,'("")') ENDIF ! IF (allocated(evc0)) DEALLOCATE(evc0) IF (allocated(sevc0)) DEALLOCATE(sevc0) IF (allocated(evc1_old)) DEALLOCATE(evc1_old) IF (allocated(evc1)) DEALLOCATE(evc1) IF (allocated(evc1_new)) DEALLOCATE(evc1_new) IF (allocated(sevc1_new)) DEALLOCATE(sevc1_new) IF (allocated(d0psi)) DEALLOCATE(d0psi) if (allocated(tg_revc0)) DEALLOCATE( tg_revc0 ) if (allocated(revc0)) DEALLOCATE( revc0 ) ! IF (project) THEN DEALLOCATE(evc0_virt) !deallocate(sevc0_virt) DEALLOCATE(F) DEALLOCATE(R) ENDIF ! IF (allocated(rho_1)) DEALLOCATE(rho_1) !if (allocated(rho_tot)) deallocate(rho_tot) IF (allocated(dmuxc)) DEALLOCATE(dmuxc) IF (allocated(igk_k)) DEALLOCATE(igk_k) IF (allocated(npw_k)) DEALLOCATE(npw_k) ! IF (allocated(eval1)) DEALLOCATE(eval1) IF (allocated(eval2)) DEALLOCATE(eval2) IF (allocated(vl)) DEALLOCATE(vl) IF (allocated(vr)) DEALLOCATE(vr) ! IF (allocated(alpha_store)) DEALLOCATE(alpha_store) IF (allocated(beta_store)) DEALLOCATE(beta_store) IF (allocated(gamma_store)) DEALLOCATE(gamma_store) IF (allocated(zeta_store)) DEALLOCATE(zeta_store) ! !Response charge density related ! IF (allocated(w_T_beta_store)) DEALLOCATE(w_T_beta_store) IF (allocated(w_T_gamma_store)) DEALLOCATE(w_T_gamma_store) IF (allocated(w_T_zeta_store)) DEALLOCATE(w_T_zeta_store) IF (allocated(chi)) DEALLOCATE(chi) IF (allocated(w_T)) DEALLOCATE(w_T) IF (allocated(rho_1_tot)) DEALLOCATE(rho_1_tot) IF (allocated(rho_1_tot_im)) DEALLOCATE(rho_1_tot_im) IF (lr_exx) CALL lr_exx_dealloc ! IF (gamma_only) THEN CALL lr_dealloc_gamma() ELSE CALL lr_dealloc_k() ENDIF ! RETURN ! CONTAINS ! SUBROUTINE lr_dealloc_gamma() ! USE becmod, ONLY : bec_type, becp, deallocate_bec_type ! IF (nkb > 0) THEN CALL deallocate_bec_type(becp) DEALLOCATE(becp1) IF (project) THEN DEALLOCATE(becp1_virt) ENDIF ENDIF ! END SUBROUTINE lr_dealloc_gamma ! SUBROUTINE lr_dealloc_k() ! USE becmod, ONLY : bec_type, becp, deallocate_bec_type ! IF (nkb > 0) THEN CALL deallocate_bec_type(becp) DEALLOCATE(becp1_c) IF (project) THEN DEALLOCATE(becp1_c_virt) ENDIF ENDIF ! END SUBROUTINE lr_dealloc_k ! END SUBROUTINE lr_dealloc !----------------------------------------------------------------------- TDDFPT/src/lr_restart.f900000755000175000017500000001610112341371472013421 0ustar mbamba! ! Copyright (C) 2004-2013 Quantum ESPRESSO group ! This file is distributed under the terms of the ! GNU General Public License. See the file `License' ! in the root directory of the present distribution, ! or http://www.gnu.org/copyleft/gpl.txt . ! !-------------------------------------------------------------------- SUBROUTINE lr_restart(iter_restart,rflag) !--------------------------------------------------------------------- ! ... restart the Lanczos recursion !--------------------------------------------------------------------- ! ! Modified by Osman Baris Malcioglu (2009) ! USE io_global, ONLY : stdout, ionode_id USE control_flags, ONLY : gamma_only USE klist, ONLY : nks, xk USE cell_base, ONLY : tpiba2 USE gvect, ONLY : g USE io_files, ONLY : tmp_dir, prefix, diropn, wfc_dir USE lr_variables, ONLY : itermax,evc1, evc1_new, sevc1_new,evc1_old, & restart, nwordrestart, iunrestart,project,nbnd_total,F,& bgz_suffix USE charg_resp, ONLY : resonance_condition, rho_1_tot , rho_1_tot_im USE wvfct, ONLY : npw, igk, nbnd, g2kin, npwx USE lr_variables, ONLY : beta_store, gamma_store, zeta_store, norm0!,real_space USE becmod, ONLY : bec_type, becp, calbec USE uspp, ONLY : vkb, nkb, okvan USE io_global, ONLY : ionode USE mp, ONLY : mp_bcast USE mp_world, ONLY : world_comm !use real_beta, only : ccalbecr_gamma,s_psir,fft_orbital_gamma,bfft_orbital_gamma USE realus, ONLY : real_space, fft_orbital_gamma, initialisation_level, & bfft_orbital_gamma, calbec_rs_gamma, add_vuspsir_gamma, & v_loc_psir, s_psir_gamma,igk_k,npw_k, & real_space_debug USE fft_base, ONLY : dfftp USE lr_variables, ONLY : lr_verbosity, charge_response, LR_polarization, n_ipol USE noncollin_module, ONLY : nspin_mag ! IMPLICIT NONE ! CHARACTER(len=6), EXTERNAL :: int_to_char ! !integer, intent(in) :: pol INTEGER, INTENT(out) :: iter_restart LOGICAL, INTENT(out) :: rflag ! ! local variables ! INTEGER :: i,ibnd,ibnd_occ,ibnd_virt,temp INTEGER :: ik, ig, ip LOGICAL :: exst CHARACTER(len=256) :: tempfile, filename,tmp_dir_saved INTEGER :: pol_index ! ! IF (lr_verbosity > 5) THEN WRITE(stdout,'("")') ENDIF pol_index=1 IF ( n_ipol /= 1 ) pol_index=LR_polarization IF (.not.restart) RETURN ! rflag = .false. ! ! Restarting kintic-energy and ultrasoft ! IF (gamma_only) THEN ! DO ig=1,npwx ! g2kin(ig)=((xk(1,1)+g(1,igk_k(ig,1)))**2 & +(xk(2,1)+g(2,igk_k(ig,1)))**2 & +(xk(3,1)+g(3,igk_k(ig,1)))**2)*tpiba2 ! ENDDO ! CALL init_us_2(npw,igk,xk(1,1),vkb) ! ENDIF ! ! Reading Lanczos coefficients ! ! filename = trim(prefix) // trim(bgz_suffix) // trim(int_to_char(LR_polarization)) tempfile = trim(tmp_dir) // trim(filename) ! INQUIRE (file = tempfile, exist = exst) ! IF (.not.exst) THEN ! WRITE( stdout,*) "WARNING: " // trim(filename) // " does not exist" rflag = .true. RETURN ! ENDIF ! ! !Ionode only reads ! ! Note Ionode file io is done in tmp_dir ! #ifdef __MPI IF (ionode) THEN #endif ! ! Read and broadcast beta gamma zeta ! OPEN (158, file = tempfile, form = 'formatted', status = 'old') ! READ(158,*,end=301,err=303) iter_restart ! IF ( iter_restart >= itermax ) iter_restart = itermax ! READ(158,*,end=301,err=303) norm0(pol_index) !XC: New structures for pseudo-hermitian algorithm beta_store(pol_index,1)=norm0(pol_index) ! DO i=1,iter_restart-1 READ(158,*,end=301,err=303) beta_store(pol_index,i+1) READ(158,*,end=301,err=303) gamma_store(pol_index,i+1) READ(158,*,end=301,err=303) zeta_store (pol_index,:,i) ENDDO READ(158,*,end=301,err=303) beta_store(pol_index,iter_restart) READ(158,*,end=301,err=303) gamma_store(pol_index,iter_restart) READ(158,*,end=301,err=303) zeta_store (pol_index,:,iter_restart) CLOSE(158) #ifdef __MPI ENDIF CALL mp_bcast (iter_restart, ionode_id, world_comm) CALL mp_bcast (norm0(pol_index), ionode_id, world_comm) CALL mp_bcast (beta_store(pol_index,:), ionode_id, world_comm) CALL mp_bcast (gamma_store(pol_index,:), ionode_id, world_comm) CALL mp_bcast (zeta_store(pol_index,:,:), ionode_id, world_comm) #endif ! ! ! Read projection ! IF (project) THEN #ifdef __MPI IF (ionode) THEN #endif filename = trim(prefix) // ".projection." // trim(int_to_char(LR_polarization)) tempfile = trim(tmp_dir) // trim(filename) ! ! OPEN (158, file = tempfile, form = 'formatted', status = 'unknown') ! READ(158,*,end=301,err=303) temp ! IF (temp /= iter_restart) CALL errore ('lr_restart', 'Iteration mismatch reading projections', 1 ) ! READ(158,*,end=301,err=303) temp !number of filled bands ! IF (temp /= nbnd) CALL errore ('lr_restart', 'NBND mismatch reading projections', 1 ) ! READ(158,*,end=301,err=303) temp !total number of bands ! IF (temp /= nbnd_total) CALL errore ('lr_restart', 'Total number of bands mismatch reading projections', 1 ) ! DO ibnd_occ=1,nbnd DO ibnd_virt=1,(nbnd_total-nbnd) READ(158,*,end=301,err=303) F(ibnd_occ,ibnd_virt,pol_index) ENDDO ENDDO ! CLOSE(158) #ifdef __MPI ENDIF CALL mp_bcast (F, ionode_id, world_comm) #endif ENDIF ! iter_restart = iter_restart + 1 ! ! Parallel reads: ! ! Note: Restart files are always in outdir ! ! ! Reading Lanczos vectors ! nwordrestart = 2 * nbnd * npwx * nks ! CALL diropn ( iunrestart, 'restart_lanczos.'//trim(int_to_char(LR_polarization)), nwordrestart, exst) ! CALL davcio(evc1(:,:,:,1),nwordrestart,iunrestart,1,-1) CALL davcio(evc1(:,:,:,2),nwordrestart,iunrestart,2,-1) CALL davcio(evc1_old(:,:,:,1),nwordrestart,iunrestart,3,-1) CALL davcio(evc1_old(:,:,:,2),nwordrestart,iunrestart,4,-1) ! CLOSE( unit = iunrestart) IF (charge_response == 1 ) THEN IF (resonance_condition) THEN CALL diropn ( iunrestart, 'restart_lanczos-rho_tot.'//trim(int_to_char(LR_polarization)), 2*dfftp%nnr, exst) CALL davcio(rho_1_tot_im(:,:),2*dfftp%nnr*nspin_mag,iunrestart,1,-1) CLOSE( unit = iunrestart) ELSE CALL diropn ( iunrestart, 'restart_lanczos-rho_tot.'//trim(int_to_char(LR_polarization)), 2*dfftp%nnr, exst) CALL davcio(rho_1_tot(:,:),2*dfftp%nnr*nspin_mag,iunrestart,1,-1) CLOSE( unit = iunrestart) ENDIF ENDIF ! ! End of all file i/o for restart ! RETURN 301 CALL errore ('restart', 'A File is corrupted, file ended unexpectedly', 1 ) 303 CALL errore ('restart', 'A File is corrupted, error in reading data', 1) END SUBROUTINE lr_restart !----------------------------------------------------------------------- TDDFPT/src/lr_dav_debug.f900000644000175000017500000002151712341371472013661 0ustar mbamba!!---------------------------------------------------------------------------- module lr_dav_debug !---------------------------------------------------------------------------- ! Created by Xiaochuan Ge (Aprile, 2013) !----------------------------------------------------------------------- contains ! subroutine for debug subroutine check_orth() !------------------------------------------------------------------------------- ! Created by X.Ge in Jan. 2013 !------------------------------------------------------------------------------- use lr_dav_variables use io_global, only : stdout use lr_us, only : lr_dot_us use uspp, only : okvan implicit none complex(kind=dp),external :: lr_dot integer :: ia, ib real(dp) :: inner_err,temp inner_err=0.0d0 do ia = 1, num_basis do ib = 1, num_basis if( poor_of_ram .or. .not. okvan) then inner_matrix(ia,ib)=dble(lr_dot_us(vec_b(:,:,1,ia),vec_b(:,:,1,ib))) else inner_matrix(ia,ib)=dble(lr_dot(svec_b(:,:,1,ia),vec_b(:,:,1,ib))) endif if(ia==ib) then temp=(inner_matrix(ia,ib)-1)**2 else temp=inner_matrix(ia,ib)**2 endif inner_err=inner_err+temp if(temp .gt. 10E-10) & &write(stdout,*) "Warning, the inner product between ",ia," and ",ib," is : ",temp enddo enddo inner_err=inner_err/(num_basis*num_basis) write(stdout,'(/5x,"The error of the orthonalization of the basis & is:",5x,E20.12)') inner_err call check("inner_matrix") return end subroutine check_orth !------------------------------------------------------------------------------- subroutine check(flag_check) !------------------------------------------------------------------------------- ! Created by X.Ge in Jan. 2013 !------------------------------------------------------------------------------- ! For debuging use lr_dav_variables use kinds, only : dp use io_global, only : stdout USE wvfct, ONLY : nbnd,npwx USE klist, ONLY : nks use lr_variables, only : evc0, sevc0 implicit none integer :: ia,ib character(len=*) :: flag_check if(.not. dav_debug) return write(stdout,'(/5x,"You are checking some information for debugging")') if(flag_check == "M_C") then write(stdout, '(7x,"Matrix C is:")') do ia=1,num_basis write(stdout,'(7x,10F15.8)') (dble(M_C(ia,ib)),ib=1,min(10,num_basis)) enddo endif if(flag_check == "M_D") then write(*, '(7x,"Matrix D is:")') do ia=1,num_basis write(stdout,'(7x,10F15.8)') (dble(M_D(ia,ib)),ib=1,min(10,num_basis)) enddo endif if(flag_check == "M") then write(*, '(7x,"Matrix DC is:")') do ia=1,num_basis write(stdout,'(7x,10F15.8)') (dble(M(ia,ib)),ib=1,min(10,num_basis)) enddo endif if(flag_check == "right_M") then write(*, '(7x,"Matrix right_M is:")') do ia=1,num_basis write(stdout,'(7x,10F15.8)') (dble(right_M(ia,ib)),ib=1,min(10,num_basis)) enddo endif if(flag_check == "left_M") then write(*, '(7x,"Matrix left_M is:")') do ia=1,num_basis write(stdout,'(7x,10F15.8)') (dble(left_M(ia,ib)),ib=1,min(10,num_basis)) enddo endif if(flag_check == "inner_matrix") then write(*, '(7x,"Inner_matrix is:")') do ia=1,num_basis write(stdout,'(7x,10F15.8)') (dble(inner_matrix(ia,ib)),ib=1,min(10,num_basis)) enddo endif return end subroutine check !------------------------------------------------------------------------------- subroutine check_overlap(vec) !------------------------------------------------------------------------------- ! Created by X.Ge in Apr. 2013 !------------------------------------------------------------------------------- ! To see if the vector is othogonal to occupied space use lr_variables, only : evc0 use wvfct, only : nbnd,npwx use io_global, only : stdout use kinds, only : dp use lr_us, only : lr_dot_us implicit none complex(dp) :: vec(npwx,nbnd),occupy(npwx,nbnd), overlap integer :: i,j overlap=0.0d0 do i = 1, nbnd do j = 1, nbnd occupy(:,j)=evc0(:,i,1) enddo overlap=overlap+lr_dot_us(vec(:,:),occupy(:,:)) enddo write(stdout,'("!!!! the tot overlap with the occupied space is:",5x,E20.12)') dble(overlap) return end subroutine check_overlap !------------------------------------------------------------------------------- subroutine check_overlap_basis(vec) !------------------------------------------------------------------------------- ! Created by X.Ge in Apr. 2013 !------------------------------------------------------------------------------- ! Check the overlap between residue and basis use lr_variables, only : evc0 use wvfct, only : nbnd,npwx use kinds, only : dp use io_global, only : stdout use lr_dav_variables, only : vec_b,num_basis implicit none complex(kind=dp),external :: lr_dot complex(dp) :: vec(npwx,nbnd),overlap integer :: i overlap=0.0d0 do i = 1, num_basis overlap = overlap + lr_dot(vec(:,:),vec_b(:,:,1,i))**2 enddo write(stdout,'("!!!! the tot overlap of the residue with the basis space is:",5x,E20.12)') dble(overlap) return end subroutine check_overlap_basis !------------------------------------------------------------------------------- subroutine check_revc0() !------------------------------------------------------------------------------- ! Created by X.Ge in Apr. 2013 !------------------------------------------------------------------------------- ! Due to the bug of virt_read, this is to check if revc0 is correct use lr_variables, only : evc0, revc0 use wvfct, only : nbnd, npwx use kinds, only : dp use fft_base, only : dffts use mp_global, only : intra_bgrp_comm use mp_world, only : world_comm use mp, only : mp_sum, mp_barrier use lr_dav_variables USE cell_base, ONLY : omega USE wavefunctions_module, ONLY : psic USE realus, ONLY : fft_orbital_gamma, bfft_orbital_gamma USE gvect, ONLY : gstart implicit none integer :: i,tot_nnr real(dp) :: norm,banda(dffts%nnr),bandb(dffts%nnr) real(kind=dp), external :: ddot complex(kind=dp),external :: lr_dot complex(dp) :: wfck(npwx,1) ALLOCATE( psic(dffts%nnr) ) tot_nnr=dffts%nr1x*dffts%nr2x*dffts%nr3x do i = 1, nbnd,2 banda(:)=dble(revc0(:,i,1)) bandb(:)=aimag(revc0(:,i,1)) wfck(:,1)=evc0(:,i,1) call fft_orbital_gamma(wfck(:,:),1,1) ! FFT: v -> psic norm=DDOT(dffts%nnr,psic(:),2,banda,1)/tot_nnr #ifdef __MPI call mp_barrier( world_comm ) call mp_sum(norm,intra_bgrp_comm) #endif print *, norm wfck(:,1)=evc0(:,i+1,1) call fft_orbital_gamma(wfck(:,:),1,1) ! FFT: v -> psic norm=DDOT(dffts%nnr,psic(:),2,bandb,1)/tot_nnr #ifdef __MPI call mp_barrier( world_comm ) call mp_sum(norm,intra_bgrp_comm) #endif print *, norm enddo !call mp_stop(100) return end subroutine check_revc0 !------------------------------------------------------------------------------- subroutine check_hermitian() !------------------------------------------------------------------------------- ! Created by X.Ge in Apr. 2013 !------------------------------------------------------------------------------- use lr_dav_variables use lr_variables, only : evc0,sevc0 use kinds, only : dp use lr_us, only : lr_dot_us implicit none integer :: ibr,ibl,ibr0,ibl0 real(dp) :: diff,diffmax do ibr = 1, num_basis call lr_apply_liouvillian(vec_b(:,:,:,ibr),vecwork(:,:,:),svecwork(:,:,:),.true.) call lr_ortho(vecwork(:,:,:), evc0(:,:,1), 1, 1,sevc0(:,:,1),.true.) do ibl = 1, num_basis M_C(ibl,ibr)=lr_dot_us(vec_b(1,1,1,ibl),vecwork(1,1,1)) enddo enddo diffmax=0.0d0 ibr0=1;ibl0=1 do ibr = 1, num_basis-1 do ibl = ibr+1, num_basis diff = abs(dble(M_C(ibl,ibr))-dble(M_C(ibr,ibl))) print *, diff,dble(M_C(ibl,ibr)),dble(M_C(ibr,ibl)) if( diff .gt. diffmax ) then diffmax=diff ibr0=ibr;ibl0=ibl endif enddo enddo print *, "Max|C(i,j)-C(j,i)|=",diffmax print *, "i,j=",ibl0,ibr0 print *, "C(i,j);C(j,i)",dble(M_C(ibl0,ibr0)),dble(M_C(ibr0,ibl0)) end subroutine check_hermitian !------------------------------------------------------------------------------- END MODULE lr_dav_debug TDDFPT/src/lr_main.f900000755000175000017500000003201612341371472012664 0ustar mbamba! ! Copyright (C) 2004-2013 Quantum ESPRESSO group ! This file is distributed under the terms of the ! GNU General Public License. See the file `License' ! in the root directory of the present distribution, ! or http://www.gnu.org/copyleft/gpl.txt . ! !-------------------------------------------------------------------- PROGRAM lr_main !--------------------------------------------------------------------- ! Brent Walker, ICTP, 2004 ! Dario Rocca, SISSA, 2006 ! O. Baris Malcioglu, SISSA, 2008 !--------------------------------------------------------------------- ! ... overall driver routine for applying lanczos algorithm ! ... to the matrix of equations coming from tddft ! ... spectrum version !--------------------------------------------------------------------- ! ! USE lr_lanczos, ONLY : one_lanczos_step USE io_global, ONLY : stdout USE kinds, ONLY : dp USE lr_variables, ONLY : restart, restart_step,& itermax, lr_verbosity,& evc1, evc1_old,norm0, charge_response,& n_ipol, d0psi, & LR_iteration, LR_polarization, & plot_type, no_hxc, nbnd_total, project, F,R, & itermax_int, revc0, lr_io_level, code USE io_files, ONLY : nd_nmbr USE global_version, ONLY : version_number USE charg_resp, ONLY : lr_calc_w_T, read_wT_beta_gamma_z, & lr_dump_rho_tot_compat1, lr_dump_rho_tot_cube,& lr_dump_rho_tot_xyzd,lr_dump_rho_tot_xcrys,& lr_dump_rho_tot_pxyd,chi,lr_calc_R,w_t_norm0_store,& resonance_condition, lr_dump_rho, lr_calc_project, lr_project_init USE ions_base, ONLY : tau,nat,atm,ityp USE environment, ONLY: environment_start USE mp_global, ONLY : nimage, mp_startup, init_index_over_band, inter_bgrp_comm USE wvfct, ONLY : nbnd USE wavefunctions_module, ONLY : psic USE control_flags, ONLY : tddfpt USE check_stop, ONLY : check_stop_now, check_stop_init USE funct, ONLY : dft_is_hybrid USE fft_base, ONLY : dffts #ifdef __ENVIRON USE plugin_flags, ONLY : use_environ USE environ_info, ONLY : environ_summary #endif !Debugging USE lr_variables, ONLY: check_all_bands_gamma, check_density_gamma,check_vector_gamma ! IMPLICIT NONE ! ! Local variables ! INTEGER :: ip,pol_index,ibnd_occ,ibnd_virt,ibnd INTEGER :: iter_restart,iteration LOGICAL :: rflag, nomsg, tg_tmp COMPLEX(kind=dp) :: sum_F,sum_c,temp ! ! pol_index=1 ! #ifdef __MPI CALL mp_startup ( ) #endif CALL environment_start ( code ) ! CALL start_clock('lr_main') ! IF (lr_verbosity > 5) THEN WRITE(stdout,'("")') ENDIF ! ! Let the PHonon and Environ routines know that ! they are doing tddfpt. ! tddfpt=.TRUE. ! ! Reading input file and PWSCF xml, some initialisation ! CALL lr_readin ( ) ! ! Writing a summary to the standard output ! about Environ variables ! #ifdef __ENVIRON IF ( use_environ ) CALL environ_summary() #endif ! CALL check_stop_init() ! ! Initialisation of degauss/openshell related stuff CALL lr_init_nfo() ! ! Allocate and zero lr variables CALL lr_alloc_init() ! ! Now print some preamble info about the run to stdout CALL lr_print_preamble() ! ! Read in ground state wavefunctions CALL lr_read_wf() ! CALL init_index_over_band(inter_bgrp_comm,nbnd) ! tg_tmp = dffts%have_task_groups ! Set up initial response orbitals IF ( test_restart(1) ) THEN CALL lr_read_d0psi() ELSE CALL lr_solve_e() ENDIF !do ip = 1, n_ipol ! temp=wfc_dot(ibnd) !enddo dffts%have_task_groups = tg_tmp ! DEALLOCATE( psic ) ! IF(project) THEN call lr_project_init ENDIF ! ! Set up initial stuff for derivatives CALL lr_dv_setup() ! ! Coordinates of the read atom, just in case IF (lr_verbosity > 1) THEN WRITE(stdout,'(/,5X,"Positions of atoms in internal coordinates")') DO ip=1,nat ! I am using ip here as a counter over atoms WRITE(stdout,'(5X,A3,2X,3F15.8)') atm(ityp(ip)),tau(1:3,ip) ENDDO ENDIF ! ! Lanczos loop where the real work happens DO ip=1, n_ipol IF (n_ipol/=1) THEN LR_polarization=ip pol_index=LR_polarization ENDIF IF (charge_response == 1 ) THEN ! Read precalculated beta gamma z CALL read_wT_beta_gamma_z() CALL lr_calc_w_T() ENDIF IF (test_restart(2)) THEN CALL lr_restart(iter_restart,rflag) CALL lr_read_d0psi() WRITE(stdout,'(/5x,"Restarting Lanczos loop",1x,i8)') LR_polarization ELSE CALL lr_read_d0psi() evc1(:,:,:,1) = d0psi(:,:,:,pol_index) evc1(:,:,:,2) = d0psi(:,:,:,pol_index) evc1_old(:,:,:,1) = cmplx(0.0d0,0.0d0) evc1_old(:,:,:,2) = cmplx(0.0d0,0.0d0) ! The new structure doesn't need it here ! CALL lr_normalise( evc1(:,:,:,1), norm0(pol_index) ) ! evc1(:,:,:,2) = evc1(:,:,:,1) ! iter_restart=1 ! WRITE(stdout,'(/5x,"Starting Lanczos loop",1x,i8)') LR_polarization ENDIF ! CALL sd0psi() !after this d0psi is Sd0psi !OBM:Check if this is really necessary lancz_loop1 : DO iteration = iter_restart, itermax LR_iteration=iteration WRITE(stdout,'(/5x,"Lanczos iteration:",1x,i8,3x"Pol:",i1,i8)') LR_iteration, ip CALL one_lanczos_step() IF ( lr_io_level > 0 .and. (mod(LR_iteration,restart_step)==0 .or. & LR_iteration==itermax .or. LR_iteration==1) )& CALL lr_write_restart() ! ! Check to see if the wall time limit has been exceeded. ! if it has exit gracefully saving the last set of Lanczos ! iterations. IF ( check_stop_now() ) THEN CALL lr_write_restart() ! Deallocate pw variables CALL clean_pw( .FALSE. ) CALL stop_clock('lr_main') CALL print_clock_lr() CALL stop_lr( .FALSE. ) ENDIF ENDDO lancz_loop1 ! IF (charge_response == 1 ) THEN ! ! Write the apropriate charge density plot. CALL lr_dump_rho (plot_type) ENDIF IF (project) THEN ! ! Calculate projections onto virtual states if required. CALL lr_calc_project(ip) ENDIF ENDDO ! ! WRITE(stdout,'(5x,"End of Lanczos iterations")') ! IF (project .and. n_ipol == 3) THEN ! ! Final projection and report (if required). CALL lr_calc_project(4) ENDIF ! ! Deallocate pw variables CALL clean_pw( .false. ) WRITE(stdout,'(5x,"Finished linear response calculation...")') CALL stop_clock('lr_main') CALL print_clock_lr() CALL stop_lr( .TRUE. ) IF (lr_verbosity > 5) THEN WRITE(stdout,'("")') ENDIF !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! !Additional small-time subroutines !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! CONTAINS SUBROUTINE lr_print_preamble() USE lr_variables, ONLY : no_hxc USE uspp, ONLY : okvan USE funct, only : dft_is_hybrid IMPLICIT NONE ! WRITE( stdout, '(/5x,"----------------------------------------")' ) ! WRITE( stdout, '(/5x,"")' ) ! WRITE( stdout, '(/5x,"Please cite this project as: ")' ) ! WRITE( stdout, '(/5x,"O.B. Malcioglu, R. Gebauer, D. Rocca, S. Baroni,")' ) ! WRITE( stdout, '(/5x,"""turboTDDFT – a code for the simulation of molecular")' ) ! WRITE( stdout, '(/5x,"spectra using the Liouville-Lanczos approach to")' ) ! WRITE( stdout, '(/5x,"time-dependent density-functional perturbation theory""")' ) ! WRITE( stdout, '(/5x,"CPC, 182, 1744 (2011)")' ) ! WRITE( stdout, '(/5x,"----------------------------------------")' ) ! IF(okvan) WRITE( stdout, '(/5x,"Ultrasoft (Vanderbilt) Pseudopotentials")' ) ! WRITE(stdout,'(/,5X,"Lanczos linear response spectrum calculation")') WRITE(stdout,'(5x,"Number of Lanczos iterations = ",i6)') itermax ! IF (no_hxc) THEN WRITE(stdout,'(5x,"No Hartree/Exchange/Correlation")') ELSEIF (dft_is_hybrid()) THEN WRITE(stdout, '(/5x,"Use of exact-exchange enabled. Note the EXX correction to the [H,X]", & &/5x,"commutator is NOT included hence the f-sum rule will be violated.")') ENDIF ! END SUBROUTINE lr_print_preamble LOGICAL FUNCTION test_restart(test_this) !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! !This tests whether the restart flag is applicable !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! USE lr_variables, ONLY : n_ipol,LR_polarization,restart,bgz_suffix USE io_files, ONLY: prefix, tmp_dir, nd_nmbr, wfc_dir USE mp, ONLY : mp_bcast, mp_barrier,mp_sum USE mp_world, ONLY : world_comm USE io_global, ONLY : ionode, ionode_id IMPLICIT NONE INTEGER, INTENT(in) :: test_this CHARACTER(len=256) :: tempfile, filename, tmp_dir_saved LOGICAL :: exst CHARACTER(len=6), EXTERNAL :: int_to_char INTEGER :: i, temp_restart ! !test_this= 1 : d0psi files !test_this= 2 : lanczos restart files temp_restart=0 !print *, "test_restart with restart=",restart IF (.not.restart) THEN test_restart = .false. RETURN ENDIF test_restart=.true. IF (test_this == 1) THEN ! !Check for parallel i/o files that are in wfc_dir tmp_dir_saved = tmp_dir IF ( wfc_dir /= 'undefined' ) tmp_dir = wfc_dir ! IF ( n_ipol == 1 ) THEN filename = trim(prefix)//'.d0psi.'//trim(int_to_char(LR_polarization)) tempfile = trim(tmp_dir) // trim(filename) //nd_nmbr INQUIRE (file = tempfile, exist = exst) !print *, tempfile," exst=",exst IF (.not. exst) THEN temp_restart=1 ENDIF ELSE DO i=1, n_ipol filename = trim(prefix)//'.d0psi.'//trim(int_to_char(i)) tempfile = trim(tmp_dir) // trim(filename) //nd_nmbr INQUIRE (file = tempfile, exist = exst) !print *, tempfile," exst=",exst IF (.not. exst) THEN temp_restart=1 ENDIF ENDDO ENDIF tmp_dir = tmp_dir_saved IF ( wfc_dir /= 'undefined' ) THEN ! check if these files can be read from outdir instead of wfcdir ! IF ( n_ipol == 1 ) THEN filename = trim(prefix)//'.d0psi.'//trim(int_to_char(LR_polarization)) tempfile = trim(tmp_dir) // trim(filename) //nd_nmbr INQUIRE (file = tempfile, exist = exst) IF (exst) THEN temp_restart=0 ENDIF ELSE DO i=1, n_ipol filename = trim(prefix)//'.d0psi.'//trim(int_to_char(i)) tempfile = trim(tmp_dir) // trim(filename) //nd_nmbr INQUIRE (file = tempfile, exist = exst) IF (exst) THEN temp_restart=0 ENDIF ENDDO ENDIF ENDIF ENDIF !for test_this = 1 IF (test_this == 2) THEN !Restart files are always written in outdir IF ( n_ipol == 1 ) THEN filename = trim(prefix)//'.restart_lanczos.'//trim(int_to_char(LR_polarization)) tempfile = trim(tmp_dir) // trim(filename) //nd_nmbr ELSE filename = trim(prefix)//'.restart_lanczos.'//trim(int_to_char(LR_polarization)) tempfile = trim(tmp_dir) // trim(filename)//nd_nmbr ENDIF INQUIRE (file = tempfile, exist = exst) !print *, tempfile," exst=",exst IF (.not. exst) THEN temp_restart=1 ENDIF ! !End of parallel file i/o ! IF ( n_ipol == 1 ) THEN filename = trim(prefix) // trim(bgz_suffix) // trim(int_to_char(LR_polarization)) tempfile = trim(tmp_dir) // trim(filename) ELSE filename = trim(prefix) // trim(bgz_suffix) // trim(int_to_char(LR_polarization)) tempfile = trim(tmp_dir) // trim(filename) ENDIF INQUIRE (file = tempfile, exist = exst) !print *, tempfile," exst=",exst IF (.not. exst) THEN temp_restart=1 ENDIF ENDIF !for test_this = 2 !print *,"temp_restart",temp_restart #ifdef __MPI CALL mp_sum(temp_restart,world_comm) #endif !print *, "current temp_restart", temp_restart IF (temp_restart > 0 ) THEN !print *,"restart falsified",nd_nmbr !WRITE(stdout,'(5X,A,3X,"is missing, unable to restart.")') offender WRITE(stdout,'(5X,"There are missing files!")') IF (test_this==1) WRITE(stdout,'(5X,"d0psi files can not be found,trying to recompansate")') IF (test_this==2) WRITE(stdout,'(5X,"lanczos restart files can not be found, starting run from scratch")') test_restart=.false. ENDIF RETURN END FUNCTION test_restart END PROGRAM lr_main !----------------------------------------------------------------------- TDDFPT/src/lr_dot.f900000755000175000017500000000553312341371472012532 0ustar mbamba!----------------------------------------------------------------------- ! FUNCTION lr_dot(x,y) !--------------------------------------------------------------------- ! Brent Walker, ICTP, 2004 !--------------------------------------------------------------------- ! ... wrapper for PWSCF linear response inner product routines ! ... sums over the bands ! ... call for each k-point with arguments: ! ... call lr_dot(npw_k(ik),evc1(1,1,ik,1),1,evc1(1,1,ik,2),1) !--------------------------------------------------------------------- ! Modified by Osman Baris Malcioglu (2009) ! USE io_global, ONLY : stdout USE kinds, ONLY : dp USE klist, ONLY : nks !use lr_variables, only : npw_k USE realus, ONLY : npw_k USE lsda_mod, ONLY : nspin USE wvfct, ONLY : npwx,nbnd,wg USE control_flags, ONLY : gamma_only USE gvect, ONLY : gstart USE mp, ONLY : mp_sum USE mp_global, ONLY : inter_pool_comm, intra_bgrp_comm USE lr_variables, ONLY : lr_verbosity USE io_global, ONLY : stdout ! IMPLICIT NONE ! COMPLEX(kind=dp) :: x(npwx,nbnd,nks),y(npwx,nbnd,nks) COMPLEX(kind=dp) :: lr_dot COMPLEX(kind=dp) :: temp_k real(kind=dp) :: temp_gamma real(kind=dp) :: degspin INTEGER :: ibnd INTEGER :: ik real(kind=dp), EXTERNAL :: DDOT COMPLEX(kind=dp), EXTERNAL :: zdotc ! IF (lr_verbosity > 5) THEN WRITE(stdout,'("")') ENDIF CALL start_clock ('lr_dot') ! lr_dot=(0.0d0,0.0d0) ! temp_gamma=0.0d0 temp_k=(0.0d0,0.0d0) ! degspin=2.0d0 IF(nspin==2) degspin=1.0d0 ! IF(gamma_only) THEN CALL lr_dot_gamma() lr_dot=cmplx(temp_gamma,0.0d0,dp) ELSE CALL lr_dot_k() lr_dot=temp_k ENDIF ! lr_dot=lr_dot/degspin ! IF (lr_verbosity > 5) WRITE(stdout,'("")') CALL stop_clock ('lr_dot') ! RETURN ! CONTAINS ! SUBROUTINE lr_dot_gamma ! DO ibnd=1,nbnd ! temp_gamma = temp_gamma + 2.D0*wg(ibnd,1)*DDOT(2*npw_k(1),x(:,ibnd,1),1,y(:,ibnd,1),1) IF (gstart==2) temp_gamma = temp_gamma - wg(ibnd,1)*dble(x(1,ibnd,1))*dble(y(1,ibnd,1)) ! ENDDO ! #ifdef __MPI !call reduce(1,temp_gamma) CALL mp_sum(temp_gamma, intra_bgrp_comm) #endif ! RETURN END SUBROUTINE lr_dot_gamma ! SUBROUTINE lr_dot_k ! DO ik=1,nks DO ibnd=1,nbnd ! temp_k=temp_k+wg(ibnd,ik)*zdotc(npw_k(ik),x(1,ibnd,ik),1,y(1,ibnd,ik),1) ! ENDDO ENDDO #ifdef __MPI !call poolreduce(2,temp_k) CALL mp_sum(temp_k,inter_pool_comm) !call reduce(2,temp_k) CALL mp_sum(temp_k, intra_bgrp_comm) #endif ! RETURN END SUBROUTINE lr_dot_k ! END FUNCTION lr_dot !----------------------------------------------------------------------- TDDFPT/src/lr_calc_dens.f900000755000175000017500000005426412341371472013664 0ustar mbamba!----------------------------------------------------------------------- SUBROUTINE lr_calc_dens( evc1, response_calc ) !--------------------------------------------------------------------- ! ... calculates response charge density from linear response ! ... orbitals and ground state orbitals !--------------------------------------------------------------------- ! ! Modified by Osman Baris Malcioglu in 2009 ! ! Input : evc1 (qdash etc) ! Output: rho_1 (=2*sum_v (revc0_v(r) . revc1_v(r,w) ) ! where v:valance state index, r denotes a transformation t ! ! In case of US PP, becsum is also calculated here ! In case of charge response calculation, the rho_tot is calculated here ! USE ions_base, ONLY : ityp, nat, ntyp=>nsp USE cell_base, ONLY : omega USE ener, ONLY : ef USE gvecs, ONLY : nls, nlsm, doublegrid USE fft_base, ONLY : dffts, dfftp USE fft_interfaces, ONLY : invfft USE io_global, ONLY : stdout USE kinds, ONLY : dp USE klist, ONLY : nks,xk,wk USE lr_variables, ONLY : evc0,revc0,rho_1,lr_verbosity,& & charge_response, itermax,& & cube_save, LR_iteration,& & LR_polarization, project,& & evc0_virt, F,nbnd_total,& & n_ipol, becp1_virt, rho_1c,& & lr_exx USE lsda_mod, ONLY : current_spin, isk USE wavefunctions_module, ONLY : psic USE wvfct, ONLY : nbnd, et, wg, npwx, npw USE control_flags, ONLY : gamma_only USE uspp, ONLY : vkb, nkb, okvan, qq, becsum USE uspp_param, ONLY : upf, nh USE io_global, ONLY : ionode, stdout USE io_files, ONLY : tmp_dir, prefix USE mp, ONLY : mp_sum USE mp_global, ONLY : inter_pool_comm, intra_bgrp_comm,& inter_bgrp_comm USE realus, ONLY : igk_k,npw_k, addusdens_r USE charg_resp, ONLY : w_T, lr_dump_rho_tot_cube,& & lr_dump_rho_tot_xyzd, & & lr_dump_rho_tot_xcrys,& & resonance_condition, epsil,& & rho_1_tot, rho_1_tot_im USE noncollin_module, ONLY : nspin_mag USE control_flags, ONLY : tqr USE becmod, ONLY : becp USE lr_exx_kernel, ONLY : lr_exx_kernel_int, revc_int,& & revc_int_c USE constants, ONLY : eps12 ! IMPLICIT NONE ! CHARACTER(len=6), EXTERNAL :: int_to_char ! COMPLEX(kind=dp), INTENT(in) :: evc1(npwx,nbnd,nks) LOGICAL, INTENT(in) :: response_calc ! ! functions REAL(kind=dp) :: ddot ! ! local variables INTEGER :: ir, ik, ibnd, jbnd, ig, ijkb0, np, na INTEGER :: ijh,ih,jh,ikb,jkb ,ispin INTEGER :: i, j, k, l REAL(kind=dp) :: w1, w2, scal REAL(kind=dp) :: rho_sum ! ! These are temporary buffers for the response REAL(kind=dp), ALLOCATABLE :: rho_sum_resp_x(:), rho_sum_resp_y(:),& & rho_sum_resp_z(:) ! CHARACTER(len=256) :: tempfile, filename ! !OBM DEBUG COMPLEX(kind=dp),EXTERNAL :: lr_dot ! IF (lr_verbosity > 5) THEN WRITE(stdout,'("")') ENDIF ! CALL start_clock('lr_calc_dens') ! ! ALLOCATE( psic(dfftp%nnr) ) psic(:) = (0.0d0,0.0d0) IF(gamma_only) THEN rho_1(:,:) = 0.0d0 ELSE rho_1c(:,:) = 0.0d0 ENDIF ! IF(gamma_only) THEN IF (lr_exx) revc_int=0.0d0 CALL lr_calc_dens_gamma() ! ! If a double grid is used, interpolate onto the fine grid ! IF ( doublegrid ) CALL interpolate(rho_1,rho_1,1) #ifdef __MPI CALL mp_sum(rho_1, inter_bgrp_comm) #endif ! ELSE IF (lr_exx) revc_int_c=(0.0d0,0.d0) CALL lr_calc_dens_k() ! ! If a double grid is used, interpolate onto the fine grid ! IF ( doublegrid ) CALL cinterpolate(rho_1c,rho_1c,1) ! ENDIF ! ! Here we add the Ultrasoft contribution to the charge density ! response. ! IF(okvan) THEN ! IF (tqr) THEN CALL addusdens_r(rho_1,.FALSE.) ELSE CALL addusdens(rho_1) ENDIF ENDIF ! ! The psic workspace can present a memory bottleneck DEALLOCATE ( psic ) ! #ifdef __MPI IF(gamma_only) THEN CALL mp_sum(rho_1, inter_pool_comm) ELSE CALL mp_sum(rho_1c, inter_pool_comm) ENDIF #endif ! ! check response charge density sums to 0 ! IF (lr_verbosity > 0) THEN ! DO ispin = 1, nspin_mag ! rho_sum=0.0d0 rho_sum=SUM(rho_1(:,ispin)) ! #ifdef __MPI CALL mp_sum(rho_sum, intra_bgrp_comm ) #endif ! rho_sum = rho_sum * omega / (dfftp%nr1*dfftp%nr2*dfftp%nr3) ! IF (ABS(rho_sum) > eps12) THEN ! IF (tqr) THEN ! WRITE(stdout,'(5X, "lr_calc_dens: Charge drift due to & &real space implementation = " ,1X,e12.5)') rho_sum ! ELSE ! WRITE(stdout,'(5X,"lr_calc_dens: ****** response & &charge density does not sum to zero")') ! WRITE(stdout,'(5X,"lr_calc_dens: ****** response & &charge density =",1X,e12.5)') rho_sum ! WRITE(stdout,'(5X,"lr_calc_dens: ****** response & &charge density, US part =",1X,e12.5)') scal ! ENDIF ! ENDIF ! ENDDO ! ENDIF ! IF (charge_response == 2 .AND. LR_iteration /=0) THEN ! ALLOCATE( rho_sum_resp_x( dfftp%nr1 ) ) ALLOCATE( rho_sum_resp_y( dfftp%nr2 ) ) ALLOCATE( rho_sum_resp_z( dfftp%nr3 ) ) ! rho_sum_resp_x = 0.D0 rho_sum_resp_y = 0.D0 rho_sum_resp_z = 0.D0 ! DO ir=1,dfftp%nnr ! i=cube_save(ir,1)+1 j=cube_save(ir,2)+1 k=cube_save(ir,3)+1 ! rho_sum_resp_x(i)=rho_sum_resp_x(i)+rho_1(ir,1) rho_sum_resp_y(j)=rho_sum_resp_y(j)+rho_1(ir,1) rho_sum_resp_z(k)=rho_sum_resp_z(k)+rho_1(ir,1) ! ENDDO ! #ifdef __MPI CALL mp_sum(rho_sum_resp_x, intra_bgrp_comm) CALL mp_sum(rho_sum_resp_y, intra_bgrp_comm) CALL mp_sum(rho_sum_resp_z, intra_bgrp_comm) IF (ionode) THEN #endif WRITE(stdout,'(5X,"Dumping plane sums of densities for & &iteration ",I4)') LR_iteration ! filename = TRIM(prefix) // ".density_x" tempfile = TRIM(tmp_dir) // TRIM(filename) ! OPEN (158, file = tempfile, form = 'formatted', status = & &'unknown', position = 'append') ! DO i=1,dfftp%nr1 WRITE(158,*) rho_sum_resp_x(i) ENDDO ! CLOSE(158) ! filename = TRIM(prefix) // ".density_y" tempfile = TRIM(tmp_dir) // TRIM(filename) ! OPEN (158, file = tempfile, form = 'formatted', status = & &'unknown', position = 'append') ! DO i=1,dfftp%nr2 WRITE(158,*) rho_sum_resp_y(i) ENDDO ! CLOSE(158) ! filename = TRIM(prefix) // ".density_z" tempfile = TRIM(tmp_dir) // TRIM(filename) ! OPEN (158, file = tempfile, form = 'formatted', status = & &'unknown', position = 'append') ! DO i=1,dfftp%nr3 WRITE(158,*) rho_sum_resp_z(i) ENDDO ! CLOSE(158) ! #ifdef __MPI ENDIF #endif ! DEALLOCATE( rho_sum_resp_x ) DEALLOCATE( rho_sum_resp_y ) DEALLOCATE( rho_sum_resp_z ) ! ENDIF IF (charge_response == 1 .AND. response_calc) THEN IF (LR_iteration < itermax) WRITE(stdout,'(5x,"Calculating total & &response charge density")') ! the charge response, it is actually equivalent to an element of ! V^T . phi_v where V^T is the is the transpose of the Krylov ! subspace generated by the Lanczos algorithm. The total charge ! density can be written as, ! ! \sum_(lanczos iterations) (V^T.phi_v) . w_T ! ! Where w_T is the corresponding eigenvector from the solution of, ! ! (w-L)e_1 = w_T ! ! notice that rho_1 is already reduced across pools above, so no ! parallelization is necessary ! ! the lr_calc_dens corresponds to q of x only in even iterations ! IF (resonance_condition) THEN ! ! Singular matrix, the broadening term dominates, phi' has ! strong imaginary component ! ! Using BLAS here would result in cmplx(rho_1(:,1),0.0d0 ,dp) ! being copied into a NEW array due to the call being to an ! F77 funtion. ! rho_1_tot_im(1:dfftp%nnr,:) = rho_1_tot_im(1:dfftp%nnr,:) & & + w_T(LR_iteration) * cmplx(rho_1(1:dfftp%nnr,:),0.0d0,dp) ! ELSE ! ! Not at resonance. ! The imaginary part is neglected, these are the non-absorbing ! oscillations ! rho_1_tot(1:dfftp%nnr,:) = rho_1_tot(1:dfftp%nnr,:) & & + dble( w_T(LR_iteration) ) * rho_1(1:dfftp%nnr,:) ENDIF ! ENDIF ! ! CALL stop_clock('lr_calc_dens') RETURN ! CONTAINS ! SUBROUTINE lr_calc_dens_gamma ! ! Gamma_only case. ! USE becmod, ONLY : bec_type, becp, calbec USE lr_variables, ONLY : becp1, tg_revc0 USE io_global, ONLY : stdout USE realus, ONLY : real_space, fft_orbital_gamma,& & initialisation_level,& & bfft_orbital_gamma,& & calbec_rs_gamma,& & add_vuspsir_gamma, v_loc_psir,& & real_space_debug USE mp_global, ONLY : ibnd_start, ibnd_end, inter_bgrp_comm USE mp, ONLY : mp_sum USE realus, ONLY : tg_psic USE mp_global, ONLY : me_bgrp, me_pool USE fft_base, ONLY : dffts, tg_gather USE wvfct, ONLY : igk INTEGER :: ibnd_start_gamma, ibnd_end_gamma LOGICAL :: use_tg INTEGER :: v_siz, incr, ioff, idx REAL(DP), ALLOCATABLE :: tg_rho(:) ibnd_start_gamma=ibnd_start IF (MOD(ibnd_start, 2)==0) ibnd_start_gamma = ibnd_start+1 ibnd_end_gamma = MAX(ibnd_end, ibnd_start_gamma) ! ! use_tg=dffts%have_task_groups incr = 2 ! IF( dffts%have_task_groups ) THEN ! v_siz = dffts%tg_nnr * dffts%nogrp ! incr = 2 * dffts%nogrp ! ALLOCATE( tg_rho( v_siz ) ) tg_rho= 0.0_DP ! ENDIF ! DO ibnd=ibnd_start_gamma,ibnd_end_gamma,incr ! CALL fft_orbital_gamma(evc1(:,:,1),ibnd,nbnd) ! ! IF(dffts%have_task_groups) THEN ! ! Now the first proc of the group holds the first two bands ! of the 2*dffts%nogrp bands that we are processing at the same time, ! the second proc. holds the third and fourth band ! and so on ! ! Compute the proper factor for each band ! DO idx = 1, dffts%nogrp IF( dffts%nolist( idx ) == me_bgrp ) EXIT END DO ! ! Remember two bands are packed in a single array : ! proc 0 has bands ibnd and ibnd+1 ! proc 1 has bands ibnd+2 and ibnd+3 ! .... ! idx = 2 * idx - 1 ! IF( idx + ibnd - 1 < nbnd ) THEN ! IF( idx + ibnd - 1 < ibnd_end_gamma ) THEN w1 = wg( idx + ibnd - 1, 1) / omega w2 = wg( idx + ibnd , 1) / omega ELSE IF( idx + ibnd - 1 == nbnd ) THEN ! ELSE IF( idx + ibnd - 1 == ibnd_end_gamma ) THEN w1 = wg( idx + ibnd - 1, 1) / omega w2 = w1 ELSE w1 = 0.0d0 w2 = w1 END IF ! DO ir=1,dffts%tg_npp( me_bgrp + 1 ) * dffts%nr1x * dffts%nr2x tg_rho(ir)=tg_rho(ir) & +2.0d0*(w1*real(tg_revc0(ir,ibnd,1),dp)*real(tg_psic(ir),dp)& +w2*aimag(tg_revc0(ir,ibnd,1))*aimag(tg_psic(ir))) ENDDO else ! ! Set weights of the two real bands now in psic ! w1=wg(ibnd,1)/omega ! IF(ibnd 6 .AND. okvan) THEN ! The rbecp term CALL calbec_rs_gamma(ibnd,nbnd,becp%r) ! ENDIF ! ! End of real space stuff ! IF (lr_exx) CALL lr_exx_kernel_int ( evc1(:,:,1), ibnd, nbnd, 1 ) ! ENDIF ENDDO IF(dffts%have_task_groups) THEN ! ! reduce the group charge ! CALL mp_sum( tg_rho, gid = dffts%ogrp_comm ) ! ioff = 0 DO idx = 1, dffts%nogrp IF( me_bgrp == dffts%nolist( idx ) ) EXIT ioff = ioff + dffts%nr1x * dffts%nr2x * dffts%npp( dffts%nolist( idx ) + 1 ) END DO ! ! copy the charge back to the processor location ! DO ir = 1, dffts%nnr rho_1(ir,1) = rho_1(ir,1) + tg_rho(ir+ioff) END DO ! ENDIF ! ! If we have a US pseudopotential we compute here the becsum ! term. ! This corresponds to the right hand side of the formula (36) in ! the ultrasoft paper. ! ! Be careful about calling lr_calc_dens, as it modifies this ! globally. ! IF ( okvan ) THEN ! scal = 0.0d0 becsum(:,:,:) = 0.0d0 ! IF ( real_space_debug <= 6) THEN ! In real space, the value is calculated above CALL calbec(npw_k(1), vkb, evc1(:,:,1), becp) ! ENDIF ! CALL start_clock( 'becsum' ) ! DO ibnd = 1, nbnd ! scal = 0.0d0 w1 = wg(ibnd,1) ijkb0 = 0 ! DO np = 1, ntyp ! IF ( upf(np)%tvanp ) THEN ! DO na = 1, nat ! IF ( ityp(na) == np ) THEN ! ijh = 1 ! DO ih = 1, nh(np) ! ikb = ijkb0 + ih ! becsum(ijh,na,current_spin) = & becsum(ijh,na,current_spin) + & 2.d0 * w1 * becp%r(ikb,ibnd) *& & becp1(ikb,ibnd) ! scal = scal + qq(ih,ih,np) *1.d0 *& & becp%r(ikb,ibnd) * becp1(ikb,ibnd) ! ijh = ijh + 1 ! DO jh = ( ih + 1 ), nh(np) ! jkb = ijkb0 + jh ! becsum(ijh,na,current_spin) = & becsum(ijh,na,current_spin) + & w1 * 2.D0 * (becp1(ikb,ibnd) * & &becp%r(jkb,ibnd) + & becp1(jkb,ibnd) * becp%r(ikb,ibnd)) ! scal = scal + qq(ih,jh,np) * 1.d0 *& & (becp%r(ikb,ibnd) * & &becp1(jkb, ibnd) + & &becp%r(jkb,ibnd) * becp1(ikb,ibnd)) ! ijh = ijh + 1 ! ENDDO ! ENDDO ! ijkb0 = ijkb0 + nh(np) ! ENDIF ! ENDDO ! ELSE ! DO na = 1, nat ! IF ( ityp(na) == np ) ijkb0 = ijkb0 + nh(np) ! ENDDO ! ENDIF ! ENDDO ! ENDDO ! CALL stop_clock( 'becsum' ) ! ENDIF ! IF( dffts%have_task_groups ) THEN DEALLOCATE( tg_rho ) END IF ! RETURN ! END SUBROUTINE lr_calc_dens_gamma !----------------------------------------------------------------------- SUBROUTINE lr_calc_dens_k ! USE becmod, ONLY : bec_type, becp, calbec USE lr_variables, ONLY : becp1_c ! DO ik=1,nks DO ibnd=1,nbnd psic(:)=(0.0d0,0.0d0) DO ig=1,npw_k(ik) psic(nls(igk_k(ig,ik)))=evc1(ig,ibnd,ik) ENDDO ! CALL invfft ('Wave', psic, dffts) ! w1=wg(ibnd,ik)/omega ! ! loop over real space points DO ir=1,dffts%nnr rho_1c(ir,:)=rho_1c(ir,:) & +2.0d0*w1*conjg(revc0(ir,ibnd,ik))*psic(ir) ENDDO ! IF (lr_exx) CALL lr_exx_kernel_int (evc1(:,:,ik), ibnd, nbnd, ik ) ! ENDDO ! ENDDO ! ! ... If we have a US pseudopotential we compute here the becsum term ! IF ( okvan ) THEN ! DO ik =1,nks ! CALL init_us_2(npw_k(ik),igk_k(1,ik),xk(1,ik),vkb) ! scal = 0.0d0 becsum(:,:,:) = 0.0d0 ! IF ( nkb > 0 .and. okvan ) THEN ! call ccalbec(nkb,npwx,npw_k(ik),nbnd,becp,vkb,evc1) CALL calbec(npw_k(ik),vkb,evc1(:,:,ik),becp) ENDIF ! CALL start_clock( 'becsum' ) ! DO ibnd = 1, nbnd scal = 0.0d0 ! w1 = wg(ibnd,ik) ijkb0 = 0 ! DO np = 1, ntyp ! IF ( upf(np)%tvanp ) THEN ! DO na = 1, nat ! IF ( ityp(na) == np ) THEN ! ijh = 1 ! DO ih = 1, nh(np) ! ikb = ijkb0 + ih ! becsum(ijh,na,current_spin) = & becsum(ijh,na,current_spin) + & 2.d0 * w1 * & &DBLE(CONJG(becp%k(ikb,ibnd)) *& & becp1_c(ikb,ibnd,ik)) ! scal = scal + qq(ih,ih,np) * 1.d0 *& & DBLE(CONJG(becp%k(ikb,ibnd)) *& & becp1_c(ikb,ibnd,ik)) ! ijh = ijh + 1 ! DO jh = ( ih + 1 ), nh(np) ! jkb = ijkb0 + jh ! becsum(ijh,na,current_spin) = & becsum(ijh,na,current_spin) + & w1 * 2.d0 * DBLE(& & CONJG(becp1_c(ikb,ibnd,ik)) *& & becp%k(jkb,ibnd) + & becp1_c(jkb,ibnd,ik) *& & CONJG(becp%k(ikb,ibnd))) ! scal = scal + qq(ih,jh,np) * 1.d0 * & & DBLE(CONJG(becp%k(ikb,ibnd)) *& & becp1_c(jkb,ibnd,ik)+& & becp%k(jkb,ibnd) * & & CONJG(becp1_c(ikb,ibnd,ik))) ! ijh = ijh + 1 ! ENDDO ! ENDDO ! ijkb0 = ijkb0 + nh(np) ! ENDIF ! ENDDO ! ELSE ! DO na = 1, nat ! IF ( ityp(na) == np ) ijkb0 = ijkb0 + nh(np) ! ENDDO ! ENDIF ! ENDDO ! ENDDO ! CALL stop_clock( 'becsum' ) ! ENDDO ! ENDIF ! RETURN ! END SUBROUTINE lr_calc_dens_k !-------------------------------------------------------------------- END SUBROUTINE lr_calc_dens !-------------------------------------------------------------------- TDDFPT/src/lr_exx_kernel.f900000644000175000017500000010517312341371472014106 0ustar mbamba! ! Copyright (C) 2011-2013 Quantum ESPRESSO group ! This file is distributed under the terms of the ! GNU General Public License. See the file `License' ! in the root directory of the present distribution, ! or http://www.gnu.org/copyleft/gpl.txt . ! !-------------------------------------------------------------------- MODULE lr_exx_kernel !------------------------------------------------------------------ ! ! This module handles the EXX part of the Liouvillian. It requires ! all the correct initialization to have been done for the routines ! in PW/src/exx.f90 (if you can't call vexx() then this module ! won't work). It respects the divergence treatments etc set in ! exx.f90 and also uses the custom grid defined there for gamma_only ! calculations. ! ! lr_exx_alloc must be called first to allocate the appropriate ! workspaces, lr_exx_dealloc can be used to dealloc them. Also ! lr_exx_revc0_init must be called at the beginning to set up the ! EXX operator. ! !------------------------------------------------------------------ ! USE kinds, ONLY : DP USE lr_variables, ONLY : evc0, revc0 USE fft_base, ONLY : dffts USE fft_interfaces, ONLY : invfft, fwfft USE lsda_mod, ONLY : nspin USE wvfct, ONLY : nbnd, npwx, wg USE gvecs, ONLY : nls, nlsm USE gvect, ONLY : g, ngm USE klist, ONLY : xk, wk, nks USE lr_variables, ONLY : gamma_only, lr_verbosity USE realus, ONLY : fft_orbital_gamma, bfft_orbital_gamma,& & fft_orbital_k, bfft_orbital_k, igk_k, npw_k USE wavefunctions_module, ONLY : psic USE cell_base, ONLY : omega USE exx, ONLY : exxalfa, g2_convolution,& & exx_fft_g2r, exx_fft_r2g, exx_grid_convert REAL(kind=dp), PUBLIC, ALLOCATABLE :: revc_int(:,:) COMPLEX(kind=dp), PUBLIC, ALLOCATABLE :: revc_int_c(:,:,:) ! Workspaces used in the k*d_term functions. ! Used for the density like \phi(r') \psi(r') products COMPLEX(DP), PRIVATE, ALLOCATABLE :: pseudo_dens_c(:) ! Used to hold the result of \int \phi(r') \psi(r') 1/|r_12| dr' COMPLEX(DP), PRIVATE, ALLOCATABLE :: vhart(:,:) ! This holds the groundstate orbitals, in real space on the ! custom EXX grid. COMPLEX(DP), PRIVATE, ALLOCATABLE :: red_revc0(:,:,:) ! This provides the k -> q point correspondence for the ! EXX operator. INTEGER, PRIVATE, ALLOCATABLE :: k2q(:) CONTAINS SUBROUTINE lr_exx_alloc() USE exx, ONLY : nkqs USE klist, ONLY : nks IMPLICIT NONE IF (gamma_only) THEN ! ALLOCATE (vhart(exx_fft_r2g%dfftt%nnr,nspin)) ALLOCATE (pseudo_dens_c(exx_fft_g2r%dfftt%nnr)) ALLOCATE (revc_int(exx_fft_r2g%dfftt%nnr,nbnd)) ! ALLOCATE (red_revc0(exx_fft_g2r%dfftt%nnr,nbnd,nks)) red_revc0 = (0.0_dp, 0.0_dp) ! ELSE ! ALLOCATE(vhart(dffts%nnr,nspin)) ALLOCATE(pseudo_dens_c(dffts%nnr)) ALLOCATE(revc_int_c(dffts%nnr,nbnd,nks)) ! ALLOCATE(k2q(nks)) k2q=0 ! ALLOCATE(red_revc0(dffts%nnr,nbnd,nkqs)) red_revc0 = (0.0_dp, 0.0_dp) ! ENDIF ! END SUBROUTINE lr_exx_alloc ! SUBROUTINE lr_exx_dealloc() IMPLICIT NONE DEALLOCATE(pseudo_dens_c, vhart, red_revc0) ! IF(gamma_only) THEN DEALLOCATE(revc_int) ELSE DEALLOCATE(revc_int_c, k2q) ENDIF ! END SUBROUTINE lr_exx_dealloc ! SUBROUTINE lr_exx_sum_int() USE mp_global, ONLY : inter_bgrp_comm USE mp, ONLY : mp_sum CALL start_clock('lr_exx_sum') CALL mp_sum(revc_int, inter_bgrp_comm) CALL stop_clock('lr_exx_sum') RETURN END SUBROUTINE lr_exx_sum_int ! SUBROUTINE lr_exx_apply_revc_int(psi, ibnd, nbnd, kpoint) !------------------------------------------------------------------ ! ! This routine takes the interaction generated by lr_exx_kernel_int ! and applies it to psi for a specified band, ibnd. ! It handles the conversion to the smooth grid but assumes that ! lr_exx_kernel_int has been called for every band and ! lr_exx_sum_int has been called. !------------------------------------------------------------------ ! USE wvfct, ONLY : npw IMPLICIT NONE COMPLEX(DP), INTENT(INOUT) :: psi(:) INTEGER, INTENT(IN) :: ibnd, nbnd, kpoint COMPLEX(DP), ALLOCATABLE :: tempphic(:,:),temppsic(:,:), psi_t(:) INTEGER :: nrxxs, j COMPLEX(DP) :: fp, fm CALL start_clock('lr_exx_apply') nrxxs= exx_fft_r2g%dfftt%nnr IF(gamma_only) THEN ALLOCATE ( tempphic(dffts%nnr,2),temppsic(dffts%nnr,2),& & psi_t(dffts%nnr) ) tempphic = (0.0_dp, 0.0_dp) temppsic = (0.0_dp, 0.0_dp) psi_t = (0.0_dp, 0.0_dp) IF (ibnd < nbnd) THEN ! ! We need to do two bands at a time as per gamma tricks. ! tempphic(1:nrxxs,1)= 0.5d0 * CMPLX( revc_int(1:nrxxs,ibnd),& & revc_int(1:nrxxs,ibnd+1), kind=dp ) ! ! To g-space ! CALL fwfft ('CustomWave', tempphic(:,1), exx_fft_g2r%dfftt) ! ! Now separate the two bands and apply the correct nl mapping ! DO j = 1, npw fp = (tempphic(exx_fft_g2r%nlt(j),1) +& & tempphic(exx_fft_g2r%nltm(j),1))*0.5d0 fm = (tempphic(exx_fft_g2r%nlt(j),1) -& & tempphic(exx_fft_g2r%nltm(j),1))*0.5d0 temppsic( j, 1) = CMPLX( DBLE(fp), AIMAG(fm),kind=DP) temppsic( j, 2) = CMPLX(AIMAG(fp),- DBLE(fm),kind=DP) ENDDO psi_t(nls(1:npw))= temppsic(1:npw,1)+ (0.0_dp,1.0_dp)& &*temppsic(1:npw,2) psi_t(nlsm(1:npw))= CONJG(temppsic(1:npw,1)- (0.0_dp,1.0_dp)& &*temppsic(1:npw,2)) ELSE tempphic(1:nrxxs,1) = 0.5d0 * CMPLX( revc_int(1:nrxxs,ibnd),& & 0.0_dp, kind=dp ) ! ! To g-space ! CALL fwfft ('CustomWave', tempphic(:,1), exx_fft_g2r%dfftt) ! ! Correct the nl mapping for the two grids. ! temppsic(1:npw,1)=tempphic(exx_fft_g2r%nlt(1:npw),1) psi_t(nls(1:npw))=temppsic(1:npw,1) psi_t(nlsm(1:npw))=CONJG(temppsic(1:npw,1)) ! ENDIF ! DEALLOCATE ( tempphic, temppsic ) ! CALL invfft ('Wave', psi_t, dffts) ! psi(:) = psi(:) + psi_t(:) ! DEALLOCATE ( psi_t ) ! ELSE ! psi(:) = psi(:) + revc_int_c(:,ibnd,kpoint) ! ENDIF CALL stop_clock('lr_exx_apply') RETURN END SUBROUTINE lr_exx_apply_revc_int SUBROUTINE lr_exx_revc0_init(orbital, kpoint) !------------------------------------------------------------------ ! ! This routine should be called at the start of a TDDFT EXX calculation ! and it take sthe ground state orbitals (passed into 'orbital'), ! interpolates them onto the custom FFT grid used by exx.f90, and stores ! the real-space result in red_revc0(). ! ! For the kpoint version also it performs the necessary rotations to ! obtain the q points from their respective k points. !------------------------------------------------------------------ ! USE mp_global, ONLY : me_bgrp USE exx, ONLY : rir, nkqs, index_sym, index_xk USE exx, ONLY : exx_fft_g2r USE fft_base, ONLY : cgather_smooth, cscatter_smooth USE symm_base, ONLY : sname IMPLICIT NONE COMPLEX(DP), INTENT(IN) :: orbital(:,:,:) INTEGER, INTENT(IN) :: kpoint INTEGER :: ibnd, nnr_, ikq, isym, nxxs, nrxxs COMPLEX(DP), ALLOCATABLE :: psic_all(:), temppsic_all(:), temppsic(:) IF (gamma_only) THEN ! nnr_= exx_fft_g2r%dfftt%nnr ! DO ibnd=1,nbnd,2 ! CALL fft_orbital_custom_gamma(orbital(:,:,1), ibnd, nbnd,& & exx_fft_g2r) red_revc0(1:nnr_,ibnd,1)=psic(1:nnr_) ! ENDDO ELSE nxxs=dffts%nr1x * dffts%nr2x * dffts%nr3x nrxxs=dffts%nnr ! ALLOCATE(temppsic_all(1:nxxs), psic_all(1:nxxs), temppsic(1:nrxxs)) ! DO ibnd=1,nbnd ! CALL fft_orbital_k ( orbital(:,:,kpoint), ibnd, nbnd, kpoint) ! DO ikq=1,nkqs ! IF (index_xk(ikq) .NE. kpoint) CYCLE ! ! Now rotate k to q isym = ABS(index_sym(ikq) ) IF (index_sym(ikq) > 0) THEN IF (TRIM(sname(index_sym(ikq))) .EQ. "identity" ) & & k2q(kpoint) = ikq ENDIF ! #ifdef __MPI CALL cgather_smooth(psic, psic_all) IF ( me_bgrp == 0 ) & temppsic_all(1:nxxs) = psic_all(rir(1:nxxs, isym)) CALL cscatter_smooth(temppsic_all, temppsic) #else temppsic(1:nrxxs) = psic(rir(1:nrxxs, isym)) #endif IF (index_sym(ikq) < 0 ) & &temppsic(1:nrxxs) = CONJG(temppsic(1:nrxxs)) ! red_revc0(1:nrxxs, ibnd, ikq) = temppsic(:) ! ENDDO ! ENDDO ! DEALLOCATE(temppsic_all, psic_all) ! ENDIF ! RETURN ! END SUBROUTINE lr_exx_revc0_init ! SUBROUTINE lr_exx_kernel_noint ( evc, int_vect ) !------------------------------------------------------------------ ! ! This routine computes the change of the self consistent potential ! due to the perturbation. More specifically it combines the K^1d ! and K^2d terms from Ref (1) in the 'non-interacting' (lower SBR ! vectors) case. ! (In the hybrid/exx CASE non-interacting is a misnomer as Hartree ! like terms are applied even to the lower batch). ! ! (1) Rocca, Lu and Galli, J. Chem. Phys., 133, 164109 (2010) !------------------------------------------------------------------ ! USE kinds, ONLY : DP USE lr_variables, ONLY : gamma_only, lr_verbosity USE exx, ONLY : exxalfa, g2_convolution, nqs,& & index_sym, index_xkq, index_xk, rir, nkqs USE symm_base, ONLY : s USE cell_base, ONLY : bg, at USE funct, ONLY : exx_is_active USE io_global, ONLY : stdout USE mp_global, ONLY : inter_bgrp_comm, ibnd_start, ibnd_end,& & me_bgrp USE mp, ONLY : mp_sum USE fft_base, ONLY : cgather_smooth, cscatter_smooth IMPLICIT NONE ! COMPLEX(DP), INTENT(in) :: evc(npwx,nbnd,nks) COMPLEX(DP), INTENT(out) :: int_vect(npwx,nbnd,nks) ! ! REAL(kind=dp), ALLOCATABLE :: revc_int(:,:) COMPLEX(kind=dp), ALLOCATABLE :: revc_int_c(:,:,:) ! Container for the interaction ! INTEGER :: ibnd, ik ! Counters REAL(kind=dp) :: w1, w2, scale ! REAL(kind=DP), ALLOCATABLE :: fac(:) ! Varible to hold to actual interaction (1/|r-r'| or similar in g-space). INTEGER :: nxxs, nrxxs ! ! q-points related stuff INTEGER :: iq, ikq, isym, ikk REAL(DP) :: xk_cryst(3), sxk(3), xkq(3) COMPLEX(DP), ALLOCATABLE :: psic_all(:), temppsic_all(:), temppsic(:) ! INTEGER :: ibnd_start_gamma, ibnd_end_gamma ! Offset ibnd_start and ibnd_ed to avoid conflicts with gamma_tricks for ! even values ! CALL start_clock('lr_exx_noint') ! IF (lr_verbosity > 5 ) WRITE(stdout,'("")') ! ! Setup the variables that describe the FFT grid in use. IF(gamma_only) THEN ALLOCATE( fac(exx_fft_r2g%ngmt) ) nrxxs= exx_fft_g2r%dfftt%nnr ELSE ALLOCATE( fac(ngm) ) nxxs=dffts%nr1x * dffts%nr2x * dffts%nr3x nrxxs = dffts%nnr ALLOCATE(temppsic_all(1:nxxs), psic_all(1:nxxs), temppsic(1:nrxxs)) ENDIF ! fac=0.d0 ! IF (exx_is_active()) THEN scale = exxalfa ELSE scale=1.d0 ENDIF ! ! IF( gamma_only ) THEN ! ! Put the appropriate interaction in fac(). Note g2_convolution respects ! the choice of divergence treatment etc set in the initial PWscf run. ! CALL g2_convolution(exx_fft_r2g%ngmt, exx_fft_r2g%gt, xk(:,1),& & xk(:,1), fac) ! ALLOCATE(revc_int(nrxxs,nbnd)) ! revc_int=0.d0 int_vect=(0.d0,0.d0) ! ! ! If ibnd_start is even offset it so bands aren't skipped/double counted ! when we use gamma_tricks. ! ibnd_start_gamma=ibnd_start IF (MOD(ibnd_start, 2)==0) ibnd_start_gamma = ibnd_start+1 ibnd_end_gamma = MAX(ibnd_end, ibnd_start_gamma) ! DO ibnd=ibnd_start_gamma,ibnd_end_gamma,2 ! CALL fft_orbital_custom_gamma(evc(:,:,1), ibnd, nbnd,& & exx_fft_g2r) ! w1=wg(ibnd,1)/omega ! IF (ibnd 5 ) WRITE(stdout,'("")') IF(gamma_only) THEN ALLOCATE( fac(exx_fft_r2g%ngmt) ) nrxxs= exx_fft_g2r%dfftt%nnr ELSE ALLOCATE( fac(ngm) ) nxxs=dffts%nr1x * dffts%nr2x * dffts%nr3x nrxxs = dffts%nnr ALLOCATE(temppsic_all(1:nxxs), psic_all(1:nxxs), temppsic(1:nrxxs)) ENDIF ! fac=0.d0 ! IF (exx_is_active()) THEN scale = exxalfa ELSE scale=1.d0 ENDIF ! IF( gamma_only ) THEN ! CALL fft_orbital_custom_gamma( orbital, ibnd, nbnd, exx_fft_g2r ) ! w1=wg(ibnd,1)/omega ! IF (ibnd 5 ) WRITE(stdout,'(" exit")') CALL stop_clock('lr_exx_int') ! Note at this point revc_int(_c) may be incomplete ! (depending if all the bands have been processed) and still needs to be summed ! and converted to the smooth FFT grid. RETURN END SUBROUTINE lr_exx_kernel_int ! FUNCTION k1d_term_gamma(w1, w2, psi, fac_in, ibnd) RESULT (psi_int) !------------------------------------------------------------------ ! ! This routine computes the K^1d term, Eq (21) from Eq Ref (1). ! As the integral in this term remains the same throughout the ! chain it can also be calculated once for each combination of ! bands and stored in k1d_pot(). ! ! psi contains two bands of |a> with w1, w2 the associated weights ! fac_in contains the interaction W(G) and ibnd the band index n'. ! ! (1) Rocca, Lu and Galli, J. Chem. Phys., 133, 164109 (2010) !------------------------------------------------------------------ ! IMPLICIT NONE COMPLEX(KIND=DP),DIMENSION(:), INTENT(IN) :: psi REAL(KIND=DP),DIMENSION(:), INTENT(IN) :: fac_in REAL(kind=DP), INTENT(IN) :: w1, w2 REAL(KIND=DP), ALLOCATABLE :: psi_int(:,:) INTEGER, INTENT(IN) :: ibnd ! ! Workspaces ! INTEGER :: ibnd2, is, npw_, ngm_, nnr_, nnr_g2r ! npw_=exx_fft_r2g%npwt ngm_=exx_fft_r2g%ngmt nnr_=exx_fft_r2g%dfftt%nnr nnr_g2r=exx_fft_g2r%dfftt%nnr ! ALLOCATE(psi_int(nnr_g2r, nbnd)) psi_int = 0.d0 ! ! DO ibnd2=1,nbnd,1 ! ! ! Set up the pseudo density for this Hartree like interaction. ! vhart(:,:) = (0.d0,0.d0) pseudo_dens_c(:) = (0.d0,0.d0) ! ! The following code is to check if the value of ibnd2 is even or odd ! and therefore whether the REAL or IMAGINARY part of red_revc0 is to be ! used. This is because red_revc0 is stored using gamma_tricks. ! IF (MOD(ibnd2,2)==1) THEN pseudo_dens_c(1:nnr_g2r) = CMPLX( w1*DBLE(red_revc0(1:nnr_g2r,ibnd,1)) *& & DBLE(red_revc0(1:nnr_g2r,ibnd2,1)), & & w2*AIMAG(red_revc0(1:nnr_g2r,ibnd, 1)) *& & DBLE(red_revc0(1:nnr_g2r,ibnd2,1)), kind=DP ) ELSE pseudo_dens_c(1:nnr_g2r) = CMPLX( w1*DBLE(red_revc0(1:nnr_g2r,ibnd,1)) *& &AIMAG(red_revc0(1:nnr_g2r,ibnd2-1,1)),& & w2*AIMAG(red_revc0(1:nnr_g2r,ibnd,1)) *& &AIMAG(red_revc0(1:nnr_g2r,ibnd2-1,1)), kind=DP ) ENDIF ! CALL fwfft ('Custom', pseudo_dens_c, exx_fft_r2g%dfftt) ! ! hartree contribution is computed in reciprocal space ! DO is = 1, nspin ! vhart(exx_fft_r2g%nlt(1:ngm_),is) =& & pseudo_dens_c(exx_fft_r2g%nlt(1:ngm_)) *& & fac_in(1:ngm_) IF (gamma_only) vhart(exx_fft_r2g%nltm(1:ngm_),is) = & & pseudo_dens_c(exx_fft_r2g%nltm(1:ngm_)) *& & fac_in(1:ngm_) ! ! and transformed back to real space ! CALL invfft ('Custom', vhart (:, is), exx_fft_r2g%dfftt) ! ENDDO ! ! Finally return the interaction ! psi_int(1:nnr_,ibnd2) = psi_int(1:nnr_,ibnd2) & & +DBLE(vhart(1:nnr_, 1)) * DBLE(psi(1:nnr_)) & & +AIMAG(vhart(1:nnr_,1)) * AIMAG(psi(1:nnr_)) ENDDO ! ! END FUNCTION k1d_term_gamma ! FUNCTION k1d_term_k(w1, psi, fac_in, ibnd, ik,ikq) RESULT (psi_int) !------------------------------------------------------------------ ! ! This routine computes the K^1d term, Eq (21) from Eq Ref (1). ! As the integral in this term remains the same throughout the ! chain it can also be calculated once for each combination of ! bands and stored in k1d_pot(). ! ! psi contains two bands of |a> with w1, w2 the associated weights ! fac_in contains the interaction W(G) and ibnd the band index n'. ! ! (1) Rocca, Lu and Galli, J. Chem. Phys., 133, 164109 (2010) !------------------------------------------------------------------ ! IMPLICIT NONE COMPLEX(KIND=DP),DIMENSION(:), INTENT(IN) :: psi REAL(KIND=DP),DIMENSION(:), INTENT(IN) :: fac_in REAL(kind=DP), INTENT(IN) :: w1 COMPLEX(KIND=DP), ALLOCATABLE :: psi_int(:,:) INTEGER, INTENT(IN) :: ibnd, ik,ikq ! ! Workspaces ! INTEGER :: ibnd2, is ALLOCATE(psi_int(dffts%nnr, nbnd)) psi_int = (0.d0,0.d0) ! DO ibnd2=1,nbnd,1 ! ! ! Set up the pseudo density for this Hartree like interaction. ! vhart(:,:) = (0.d0,0.d0) pseudo_dens_c(:) = (0.d0,0.d0) ! pseudo_dens_c(:) = CONJG(red_revc0(:,ibnd,ikq))*& &red_revc0(:,ibnd2,k2q(ik))/omega ! CALL fwfft ('Smooth', pseudo_dens_c, dffts) ! ! hartree contribution is computed in reciprocal space ! DO is = 1, nspin ! vhart(nls(1:ngm),is) = w1*pseudo_dens_c(nls(1:ngm)) *& & fac_in(1:ngm) ! ! and transformed back to real space ! CALL invfft ('Smooth', vhart (:, is), dffts) ! ENDDO ! ! Finally return the interaction ! psi_int(:,ibnd2) = psi_int(:,ibnd2) + vhart(:,1) * psi(:) ! ENDDO ! END FUNCTION k1d_term_k ! FUNCTION k2d_term_gamma(w1, w2, psi, fac_in, ibnd) RESULT (psi_int) !------------------------------------------------------------------ ! ! This routine computes the K^2d term, Eq (22) from Eq Ref (1). ! psi contains two bands of |b> with w1, w2 the associated weights ! fac_in contains the interaction W(G) and ibnd the band index n'. ! ! (1) Rocca, Lu and Galli, J. Chem. Phys., 133, 164109 (2010) !------------------------------------------------------------------ ! IMPLICIT NONE COMPLEX(KIND=DP),DIMENSION(:), INTENT(IN) :: psi REAL(KIND=DP),DIMENSION(:), INTENT(IN) :: fac_in REAL(kind=DP), INTENT(IN) :: w1, w2 INTEGER, INTENT(IN) :: ibnd REAL(KIND=DP), ALLOCATABLE :: psi_int(:,:) ! ! Workspaces ! INTEGER :: ibnd2, is, npw_,ngm_, nnr_, nnr_g2r ! nnr_ = exx_fft_r2g%dfftt%nnr npw_ = exx_fft_r2g%npwt ngm_ = exx_fft_r2g%ngmt nnr_g2r = exx_fft_g2r%dfftt%nnr ! ALLOCATE(psi_int(nnr_g2r, nbnd)) psi_int = 0.d0 ! ! DO ibnd2=1,nbnd,1 ! ! Set up the pseudo density for this Hartree like interaction. ! vhart(:,:) = (0.d0,0.d0) pseudo_dens_c(:) = (0.d0,0.d0) ! ! The following code is to check if the value of ibnd2 is even or odd ! and therefore whether the REAL or IMAGINARY part of red_revc0 is to be ! used. This is because red_revc0 is stored using gamma_tricks. ! IF (MOD(ibnd2,2)==1) THEN pseudo_dens_c(1:nnr_g2r) = CMPLX( & & w1*DBLE(psi(1:nnr_g2r))*DBLE(red_revc0(1:nnr_g2r,ibnd2,1)),& & w2*AIMAG(psi(1:nnr_g2r))*DBLE(red_revc0(1:nnr_g2r,ibnd2,1)), kind=DP ) ELSE pseudo_dens_c(1:nnr_g2r) = CMPLX( & & w1*DBLE(psi(1:nnr_g2r))*AIMAG(red_revc0(1:nnr_g2r,ibnd2-1,1)),& & w2*AIMAG(psi(1:nnr_g2r))*AIMAG(red_revc0(1:nnr_g2r,ibnd2-1,1)), kind=DP ) ENDIF ! CALL fwfft ('Custom', pseudo_dens_c, exx_fft_r2g%dfftt) ! ! hartree contribution is computed in reciprocal space ! DO is = 1, nspin ! vhart(exx_fft_r2g%nlt(1:ngm_),is) = pseudo_dens_c(exx_fft_r2g& &%nlt(1:ngm_)) * fac_in(1:ngm_) IF (gamma_only) vhart(exx_fft_r2g%nltm(1:ngm_),is) = & & pseudo_dens_c(exx_fft_r2g%nltm(1:ngm_)) *& & fac_in(1:ngm_) ! ! and transformed back to real space ! CALL invfft ('Custom', vhart (:, is), exx_fft_r2g%dfftt) ! ENDDO ! ! ! Finally return the interaction ! psi_int(1:nnr_,ibnd2) = psi_int(1:nnr_,ibnd2) & & +DBLE(vhart(1:nnr_,1)) * DBLE(red_revc0(1:nnr_,ibnd,1)) & & +AIMAG(vhart(1:nnr_,1)) * AIMAG(red_revc0(1:nnr_,ibnd,1)) ! ENDDO ! ! END FUNCTION k2d_term_gamma ! FUNCTION k2d_term_k(w1, psi, fac_in, ibnd, ik, ikq) RESULT (psi_int) !------------------------------------------------------------------ ! ! This routine computes the K^2d term, Eq (22) from Eq Ref (1). ! psi contains two bands of |b> with w1, w2 the associated weights ! fac_in contains the interaction W(G) and ibnd the band index n'. ! ! (1) Rocca, Lu and Galli, J. Chem. Phys., 133, 164109 (2010) !------------------------------------------------------------------ ! IMPLICIT NONE COMPLEX(KIND=DP),DIMENSION(:), INTENT(IN) :: psi REAL(KIND=DP),DIMENSION(:), INTENT(IN) :: fac_in REAL(kind=DP), INTENT(IN) :: w1 INTEGER, INTENT(IN) :: ibnd, ik, ikq COMPLEX(KIND=DP), ALLOCATABLE :: psi_int(:,:) ! ! Workspaces ! INTEGER :: ibnd2, is ! ALLOCATE(psi_int(dffts%nnr, nbnd)) psi_int = (0.d0,0.d0) ! DO ibnd2=1,nbnd,1 ! ! Set up the pseudo density for this Hartree like interaction. ! vhart(:,:) = (0.d0,0.d0) pseudo_dens_c(:) = (0.d0,0.d0) ! pseudo_dens_c(:) = CONJG(psi(:))*red_revc0(:,ibnd2,k2q(ik))/omega ! CALL fwfft ('Smooth', pseudo_dens_c, dffts) ! ! hartree contribution is computed in reciprocal space ! DO is = 1, nspin ! vhart(nls(1:ngm),is) = w1*pseudo_dens_c(nls(1:ngm)) *& & fac_in(1:ngm) ! ! and transformed back to real space ! CALL invfft ('Smooth', vhart (:, is), dffts) ! ENDDO ! ! ! Finally return the interaction ! psi_int(:,ibnd2) = psi_int(:,ibnd2) + vhart(:,1) *& &red_revc0(:,ibnd,ikq) ! ENDDO ! END FUNCTION k2d_term_k !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! !! !! The following routines are wrapper functions for inv/fw fft handling both !! the custom FFT grids and gamma tricks. They are the analogues of those found !! in PW/src/realus.f90. Ideally both these and their counterparts should be !! moved somewhere else but for now they live here. !! !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! SUBROUTINE fft_orbital_custom_gamma(orbital, ibnd, nbnd, g2r) USE kinds, ONLY : DP USE fft_custom, ONLY : fft_cus IMPLICIT NONE COMPLEX(DP), INTENT(IN) :: orbital(:,:) INTEGER, INTENT(IN) :: ibnd, nbnd TYPE(fft_cus), INTENT(IN) :: g2r ! psic=(0.0_dp, 0.0_dp) ! IF (ibnd < nbnd) THEN ! psic(g2r%nlt(1:g2r%npwt)) = orbital(1:g2r%npwt,ibnd) + & &(0.0_dp, 1.0_dp) * orbital(1:g2r%npwt,ibnd+1) psic(g2r%nltm(1:g2r%npwt)) = CONJG(orbital(1:g2r%npwt,ibnd) - & &(0.0_dp, 1.0_dp) * orbital(1:g2r%npwt,ibnd+1)) ! ELSE ! psic(g2r%nlt(1:g2r%npwt)) = orbital(1:g2r%npwt,ibnd) psic(g2r%nltm(1:g2r%npwt)) =CONJG(orbital(1:g2r%npwt,ibnd)) ! ENDIF ! CALL invfft ('CustomWave', psic, exx_fft_g2r%dfftt) ! RETURN ! END SUBROUTINE fft_orbital_custom_gamma SUBROUTINE bfft_orbital_custom_gamma(orbital, ibnd, nbnd, g2r) USE kinds, ONLY : DP USE fft_custom, ONLY : fft_cus IMPLICIT NONE COMPLEX(DP), INTENT(INOUT) :: orbital(:,:) INTEGER, INTENT(IN) :: ibnd, nbnd TYPE(fft_cus), INTENT(IN) :: g2r ! Workspaces COMPLEX(DP) :: fp, fm ! Counters INTEGER :: j ! CALL fwfft ('CustomWave', psic(:), g2r%dfftt) ! IF (ibnd < nbnd) THEN ! ! two ffts at the same time DO j = 1, g2r%npwt fp = (psic(g2r%nlt(j)) + psic(g2r%nltm(j)))*0.5d0 fm = (psic(g2r%nlt(j)) - psic(g2r%nltm(j)))*0.5d0 orbital( j, ibnd) = CMPLX( DBLE(fp), AIMAG(fm),kind=DP) orbital( j, ibnd+1) = CMPLX(AIMAG(fp),- DBLE(fm),kind=DP) ENDDO ! ELSE ! orbital(1:g2r%npwt,ibnd)=psic(g2r%nlt(1:g2r%npwt)) ! ENDIF ! RETURN ! END SUBROUTINE bfft_orbital_custom_gamma END MODULE lr_exx_kernel TDDFPT/src/lr_init_nfo.f900000644000175000017500000001041112341371472013535 0ustar mbamba!-------------------------------------------------------------- !OBM This subroutine initialises stuff related to open shell ! calculations (kpoint > 1 degauss/=0 or nspin/=1) !------------------------------------------------------------- SUBROUTINE lr_init_nfo() ! !Created by Osman Baris Malcioglu (2009) ! ! USE kinds, ONLY : DP USE klist, ONLY : nks,degauss,lgauss,ngauss,xk, nelec USE wvfct, ONLY : nbnd, et, igk, npw, g2kin USE realus, ONLY : npw_k, igk_k USE lr_variables, ONLY : lr_verbosity USE io_global, ONLY : stdout USE constants, ONLY : pi, degspin USE noncollin_module, ONLY : noncolin USE mp, ONLY : mp_max, mp_min USE mp_global, ONLY : inter_pool_comm USE gvect, ONLY : ngm, g USE cell_base, ONLY : bg, tpiba, tpiba2, omega USE ener, ONLY : Ef USE ktetra, ONLY : ltetra USE lsda_mod, ONLY : lsda USE realus, ONLY : real_space USE control_ph, ONLY : alpha_pv, nbnd_occ USE wvfct, ONLY : npwx, ecutwfc USE klist, ONLY : nks USE io_files, ONLY : iunigk, seqopn ! IMPLICIT NONE ! ! local variables REAL(kind=DP) :: small, emin, emax, xmax, fac, targ INTEGER :: ik,ibnd, ipol LOGICAL :: exst ! ! Open shell related IF ( .not. allocated( igk_k ) ) ALLOCATE(igk_k(npwx,nks)) IF ( .not. allocated( npw_k ) ) ALLOCATE(npw_k(nks)) !IF ( .not. ALLOCATED( nbnd_occ ) ) allocate (nbnd_occ (nks)) CALL seqopn( iunigk, 'igk', 'UNFORMATTED', exst ) IF (.not. real_space) THEN DO ik=1,nks ! CALL gk_sort( xk(1,ik), ngm, g, ( ecutwfc / tpiba2 ), npw, igk, g2kin ) ! npw_k(ik) = npw ! igk_k(:,ik) = igk(:) ! ! For systems with more than one kpoint, we also write ! igk to iunigk. This is required by exx_init(). IF ( nks > 1 ) WRITE( iunigk ) igk ! ENDDO ENDIF !OBM!! The following part is derived from phonon phq_setup ! ! 5) Computes the number of occupied bands for each k point ! !if (.not. allocated (nbnd_occ) allocate( nbnd_occ (nks) ) IF (lgauss) THEN ! ! discard conduction bands such that w0gauss(x,n) < small ! ! hint ! small = 1.0333492677046d-2 ! corresponds to 2 gaussian sigma ! small = 6.9626525973374d-5 ! corresponds to 3 gaussian sigma ! small = 6.3491173359333d-8 ! corresponds to 4 gaussian sigma ! small = 6.9626525973374d-5 ! ! - appropriate limit for gaussian broadening (used for all ngauss) ! xmax = sqrt ( - log (sqrt (pi) * small) ) ! ! - appropriate limit for Fermi-Dirac ! IF (ngauss== - 99) THEN fac = 1.d0 / sqrt (small) xmax = 2.d0 * log (0.5d0 * (fac + sqrt (fac * fac - 4.d0) ) ) ENDIF targ = ef + xmax * degauss DO ik = 1, nks DO ibnd = 1, nbnd IF (et (ibnd, ik) 5) THEN ! real space & nkb > 0 do ibnd=1, nbnd, 2 call fft_orbital_gamma(vect(:,:,1),ibnd,nbnd) call calbec_rs_gamma(ibnd,nbnd,becp%r) call bfft_orbital_gamma(svect(:,:,1),ibnd,nbnd) enddo else CALL calbec(npw,vkb,vect(:,:,1),becp) CALL s_psi(npwx,npw,nbnd,vect(1,1,1),svect(1,1,1)) endif else ! Generalised K points algorithm do ik = 1, nks CALL init_us_2(npw_k(ik),igk_k(1,ik),xk(1,ik),vkb) CALL calbec(npw_k(ik),vkb,vect(:,:,ik),becp) CALL s_psi(npwx,npw_k(ik),nbnd,vect(1,1,ik),svect(1,1,ik)) enddo endif endif return end subroutine lr_apply_s !------------------------------------------------------------------------------- function lr_dot_us(vect1,vect2) !------------------------------------------------------------------------------- ! Created by X.Ge in May. 2013 !------------------------------------------------------------------------------- ! This routine calculates < vect1 | S | vect2 > use kinds, only : dp use wvfct, only : npwx, npw, nbnd use klist, only : nks implicit none complex(kind=dp),external :: lr_dot complex(dp) :: vect1(npwx,nbnd,nks),vect2(npwx,nbnd,nks),svect1(npwx,nbnd,nks) complex(dp) :: lr_dot_us call lr_apply_s(vect1(1,1,1),svect1(1,1,1)) lr_dot_us=lr_dot(svect1,vect2) return end function lr_dot_us !------------------------------------------------------------------------------- END MODULE lr_us TDDFPT/src/sd0psi.f900000755000175000017500000000517612341371472012454 0ustar mbamba!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! SUBROUTINE sd0psi() ! ! S * d0psi for US case ! ! Modified by Osman Baris Malcioglu (2009) ! USE klist, ONLY : nks,xk USE lr_variables, ONLY : n_ipol!, real_space USE lr_variables, ONLY : d0psi USE uspp, ONLY : vkb, nkb, okvan USE wvfct, ONLY : nbnd, npwx USE control_flags, ONLY : gamma_only USE becmod, ONLY : bec_type, becp, calbec !use real_beta, only : ccalbecr_gamma,s_psir,fft_orbital_gamma,bfft_orbital_gamma USE realus, ONLY : real_space, fft_orbital_gamma, initialisation_level, & bfft_orbital_gamma, calbec_rs_gamma, add_vuspsir_gamma, v_loc_psir, & s_psir_gamma, igk_k, npw_k, real_space_debug USE lr_variables, ONLY : lr_verbosity USE io_global, ONLY : stdout ! IMPLICIT NONE ! INTEGER :: ik, ip,ibnd ! IF (lr_verbosity > 5) THEN WRITE(stdout,'("")') ENDIF IF ( nkb==0 .or. (.not.okvan) ) RETURN ! DO ip=1,n_ipol ! IF (gamma_only) THEN ! IF (real_space_debug>4) THEN DO ibnd=1,nbnd,2 CALL fft_orbital_gamma(d0psi(:,:,1,ip),ibnd,nbnd) CALL calbec_rs_gamma(ibnd,nbnd,becp%r) CALL s_psir_gamma(ibnd,nbnd) CALL bfft_orbital_gamma(d0psi(:,:,1,ip),ibnd,nbnd) ENDDO ! makedo part until spsi is in place !call s_psi(npwx,npw_k(1),nbnd,d0psi(:,:,:,ip),d0psi(:,:,:,ip)) ELSE !call pw_gemm('Y',nkb,nbnd,npw_k(1),vkb,npwx,d0psi(:,:,:,ip),npwx,rbecp,nkb) CALL calbec(npw_k(1),vkb,d0psi(:,:,1,ip),becp) !notice the third index given as :, whereas in the above routine it is 1. Inquire. ! I think it is spin index, spin is not considered yet, leave it for later !call s_psi(npwx,npw_k(1),nbnd,d0psi(:,:,:,ip),d0psi(:,:,:,ip)) CALL s_psi(npwx,npw_k(1),nbnd,d0psi(:,:,1,ip),d0psi(:,:,1,ip)) ENDIF ! ELSE ! DO ik=1,nks ! CALL init_us_2(npw_k(ik),igk_k(1,ik),xk(1,ik),vkb) !call ccalbec(nkb,npwx,npw_k(ik),nbnd,becp,vkb,d0psi(:,:,ik,ip)) CALL calbec(npw_k(ik),vkb,d0psi(:,:,ik,ip),becp) CALL s_psi(npwx,npw_k(ik),nbnd,d0psi(:,:,ik,ip),d0psi(:,:,ik,ip)) ! ENDDO ! ENDIF ! ENDDO ! END SUBROUTINE sd0psi !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! TDDFPT/src/lr_dav_variables.f900000644000175000017500000000670412341371472014544 0ustar mbamba! Copyright (C) 2001-2003 PWSCF group ! This file is distributed under the terms of the ! GNU General Public License. See the file `License' ! in the root directory of the present distribution, ! or http://www.gnu.org/copyleft/gpl.txt . MODULE lr_dav_variables !-------------------------------------------------------------------------- ! ... sets the dimensions of the variables required in the ! ... lr_davidson algorithm !-------------------------------------------------------------------------- ! Created by Xiaochuan Ge (Oct.2012) USE kinds, ONLY : dp IMPLICIT NONE !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! ! Parameters !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! real (dp), PARAMETER :: zero=1.0E-10 real (dp), PARAMETER :: PI = 3.14159265d0 !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! ! Namelist !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! INTEGER :: num_eign, num_init, num_basis_max,max_iter,& p_nbnd_occ,p_nbnd_virt ! number of occ and virt bands for projection REAL(kind=dp) :: residue_conv_thr, reference, close_pre, broadening,start,& finish,step,turn2planb logical :: precondition,dav_debug, single_pole,& sort_contr,diag_of_h,print_spectrum,if_check_orth,& if_random_init,if_check_her,poor_of_ram,poor_of_ram2,& conv_assistant,if_dft_spectrum !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! !Global Variables !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! integer , allocatable :: & vc_couple(:,:),& ! for calculating the optimal initial vector eign_value_order(:), energy_dif_order(:) LOGICAL :: dav_conv LOGICAL :: ploted(3)=.false., done_calc_R=.false. real(dp) :: max_res logical, allocatable :: kill_left(:),kill_right(:) INTEGER :: num_basis_old, & ! num of basis that has been applied Liouvillian num_basis,toadd, & ! total number of basis lwork,info,& ! for calling lapack routine dav_iter,num_basis_tot COMPLEX (DP), ALLOCATABLE :: & vec_b(:,:,:,:), svec_b(:,:,:,:), & ! vectors for the basis of Liouvillian left_full(:,:,:,:), & right_full(:,:,:,:),& ! left and right appro. eigen vector of D*C in full space left_res(:,:,:,:), & right_res(:,:,:,:), & ! left and right residual of the appr. eigen-v vecwork(:,:,:), svecwork(:,:,:), & ! Working space for supervectors left2(:),right2(:), & ! square of the module of left_res and right_res M_C(:,:),M_D(:,:),M(:,:),& ! Matrix represented in the sub space ground_state(:,:,:),& C_vec_b(:,:,:,:), & ! D and C applied to vec_b D_vec_b(:,:,:,:), & ! D and C applied to vec_b. see documentation for explaination of D&C Fx(:,:),Fy(:,:) real(dp) :: FxR(3), FyR(3) REAL (DP), ALLOCATABLE :: & work(:) ,& ! global work space for linear algorithm routine left_M(:,:), & right_M(:,:), & ! left and right appro. eigen vectors of eign_value(:,:),& M_shadow_avatar(:,:),& inner_matrix(:,:),& tr_energy(:),& energy_dif(:),contribute(:,:),& chi_dav(:,:),total_chi(:),norm_F(:),& omegal(:),omegar(:) end module lr_dav_variables TDDFPT/src/lr_sm1_psi.f900000755000175000017500000002774612341371472013331 0ustar mbamba!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! SUBROUTINE sm1_psi( recalculate, ik, lda, n, m, psi, spsi) !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! !---------------------------------------------------------------------------- ! ! This routine applies the S^{-1} matrix to m wavefunctions psi ! and puts the results in spsi. ! Requires the products of psi with all beta functions ! in array becp(nkb,m) (calculated in h_psi or by ccalbec) ! input: ! recalculate decides if the overlap of beta functions is recalculated or not. ! this is needed e.g. if ions are moved and the overlap changes accordingly ! lda leading dimension of arrays psi, spsi ! n true dimension of psi, spsi ! m number of states psi ! psi ! output: ! spsi S^{-1}*psi ! ! Modified by Osman Baris Malcioglu (2009) USE kinds, ONLY : DP USE control_flags, ONLY : gamma_only USE uspp, ONLY : okvan, vkb, nkb, qq USE uspp_param, ONLY : nh, upf USE wvfct, ONLY : igk, g2kin USE ions_base, ONLY : ityp,nat,ntyp=>nsp USE mp, ONLY : mp_sum USE mp_global, ONLY : inter_pool_comm, intra_bgrp_comm USE lr_variables, ONLY : lr_verbosity USE io_global, ONLY : stdout ! IMPLICIT NONE ! ! ... First the dummy variables ! LOGICAL, INTENT(in) :: recalculate INTEGER, INTENT(in) :: lda, n, m, ik COMPLEX(kind=DP), INTENT(in) :: psi(lda,m) COMPLEX(kind=DP), INTENT(out) :: spsi(lda,m) ! LOGICAL ::recalc ! IF (lr_verbosity > 5) THEN WRITE(stdout,'("")') ENDIF ! CALL start_clock( 'lr_sm1_psi' ) ! recalc=recalculate IF ( gamma_only ) THEN CALL sm1_psi_gamma() ELSE ! CALL sm1_psi_k() ! ENDIF ! CALL stop_clock( 'lr_sm1_psi' ) ! RETURN ! CONTAINS !----------------------------------------------------------------------- SUBROUTINE sm1_psi_gamma() !----------------------------------------------------------------------- ! USE becmod, ONLY : bec_type,becp,calbec !use real_beta, only : ccalbecr_gamma,s_psir,fft_orbital_gamma USE realus, ONLY : real_space, fft_orbital_gamma, initialisation_level, & bfft_orbital_gamma, calbec_rs_gamma, add_vuspsir_gamma, & v_loc_psir, s_psir_gamma, real_space_debug ! IMPLICIT NONE ! ! ... local variables ! INTEGER :: ikb, jkb, ih, jh, na, nt, ijkb0, ibnd, ii ! counters real(kind=DP), ALLOCATABLE :: ps(:,:) real(kind=dp), ALLOCATABLE, SAVE :: BB_(:,:) LOGICAL, SAVE :: first_entry = .true. IF(first_entry) THEN IF(allocated(BB_)) DEALLOCATE(BB_) first_entry = .false. recalc=.true. ENDIF ! the product vkb and psi ! ! ... initialize spsi ! CALL ZCOPY( lda * m, psi, 1, spsi, 1 ) ! ! ... The product with the beta functions ! IF ( nkb == 0 .or. .not. okvan ) RETURN ! !BB_ = sum !if (allocated(BB_)) then ! print *, "BB is allocated, ", BB_(1,1) !else ! print *, "BB is not allocated" !endif !OBM - For improved restart handling IF (.not.allocated(BB_)) recalc = .true. IF (recalc .and. allocated(BB_)) DEALLOCATE(BB_) IF(recalc) THEN ALLOCATE(BB_(nkb,nkb)) BB_=0.d0 CALL errore('sm1_psi','recalculating BB_ matrix',-1) !print *, "did you see the recalculating message?" IF (lr_verbosity > 1) THEN WRITE(stdout,'(5X,"Calculating S^-1")') ENDIF !call pw_gemm('Y',nkb,nkb,n,vkb,lda,vkb,lda,BB_,nkb) CALL calbec (n,vkb,vkb,BB_,nkb) ALLOCATE( ps( nkb, nkb ) ) ps(:,:) = (0.d0) ijkb0 = 0 DO nt=1,ntyp IF (upf(nt)%tvanp) THEN DO na=1,nat IF(ityp(na)==nt) THEN DO ii=1,nkb DO jh=1,nh(nt) jkb=ijkb0 + jh DO ih=1,nh(nt) ikb = ijkb0 + ih ps(ikb,ii) = ps(ikb,ii) + qq(ih,jh,nt)*BB_(jkb,ii) ENDDO ENDDO ENDDO ijkb0 = ijkb0+nh(nt) ENDIF ENDDO ELSE DO na = 1, nat IF ( ityp(na) == nt ) ijkb0 = ijkb0 + nh(nt) ENDDO ENDIF ENDDO DO ii=1,nkb ps(ii,ii) = ps(ii,ii) + 1.d0 ENDDO CALL dinv_matrix(ps,nkb) BB_(:,:) = 0.d0 ijkb0 = 0 DO nt=1,ntyp IF (upf(nt)%tvanp) THEN DO na=1,nat IF(ityp(na)==nt) THEN DO ii=1,nkb DO jh=1,nh(nt) jkb=ijkb0 + jh DO ih=1,nh(nt) ikb = ijkb0 + ih BB_(ii,jkb) = BB_(ii,jkb) - ps(ii,ikb)*qq(ih,jh,nt) ENDDO ENDDO ENDDO ijkb0 = ijkb0+nh(nt) ENDIF ENDDO ELSE DO na = 1, nat IF ( ityp(na) == nt ) ijkb0 = ijkb0 + nh(nt) ENDDO ENDIF ENDDO DEALLOCATE(ps) ENDIF !print *, "BB is now, ", BB_(1,1) IF (real_space_debug>3) THEN !was 3 DO ibnd=1,m,2 CALL fft_orbital_gamma(psi,ibnd,m) CALL calbec_rs_gamma(ibnd,m,becp%r) ENDDO ELSE CALL calbec(n,vkb,psi,becp,m) !call pw_gemm('Y',nkb,m,n,vkb,lda,psi,lda,rbecp,nkb) ENDIF ! ALLOCATE( ps( nkb, m ) ) ! ps(:,:) = 0.D0 ! ! do ibnd=1,m ! do jkb=1,nkb ! do ii=1,nkb ! ps(jkb,ibnd) = ps(jkb,ibnd)+BB_(jkb,ii)*rbecp(ii,ibnd) ! enddo ! enddo ! enddo ! CALL DGEMM( 'N','N',nkb,m,nkb,1.d0,BB_,nkb,becp%r,nkb,0.d0,ps,nkb) ! do ibnd=1,m ! do ii=1,nkb ! call ZAXPY(n,cmplx(ps(ii,ibnd),0.0d0,dp),vkb(1,ii),1,spsi(1,ibnd),1) ! enddo ! enddo CALL DGEMM('N','N',2*n,m,nkb,1.d0,vkb,2*lda,ps,nkb,1.d0,spsi,2*lda) ! DEALLOCATE( ps ) ! RETURN ! END SUBROUTINE sm1_psi_gamma ! !----------------------------------------------------------------------- SUBROUTINE sm1_psi_k() !----------------------------------------------------------------------- ! ! ... k-points version ! USE becmod, ONLY : bec_type,becp,calbec !USE lr_variables, ONLY: igk_k, npw_k USE realus, ONLY : igk_k,npw_k USE klist, ONLY : nks, xk ! IMPLICIT NONE ! ! ... local variables ! INTEGER :: ikb, jkb, ih, jh, na, nt, ijkb0, ibnd, ii, ik1 ! counters COMPLEX(kind=DP), ALLOCATABLE :: ps(:,:) COMPLEX(kind=dp), ALLOCATABLE, SAVE :: BB_(:,:,:) ! the product vkb and psi ! ! ... initialize spsi ! CALL ZCOPY( lda * m, psi, 1, spsi, 1 ) ! ! ... The product with the beta functions ! IF ( nkb == 0 .or. .not. okvan ) RETURN ! IF (.not.allocated(BB_)) recalc = .true. IF (recalc .and. allocated(BB_)) DEALLOCATE(BB_) IF(recalc) THEN ALLOCATE(BB_(nkb,nkb,nks)) BB_=(0.d0,0.d0) CALL errore('sm1_psi','recalculating BB_ matrix',-1) ALLOCATE( ps( nkb, nkb ) ) DO ik1 = 1,nks CALL init_us_2(npw_k(ik1),igk_k(:,ik1),xk(1,ik1),vkb) CALL zgemm('C','N',nkb,nkb,npw_k(ik1),(1.d0,0.d0),vkb,lda,vkb,lda,(0.d0,0.d0),BB_(1,1,ik1),nkb) #ifdef __MPI !CALL reduce( 2 * nkb * nkb, BB_(:,:,ik1) ) CALL mp_sum(BB_(:,:,ik1), intra_bgrp_comm) #endif ps(:,:) = (0.d0,0.d0) ijkb0 = 0 DO nt=1,ntyp IF (upf(nt)%tvanp) THEN DO na=1,nat IF(ityp(na)==nt) THEN DO ii=1,nkb DO jh=1,nh(nt) jkb=ijkb0 + jh DO ih=1,nh(nt) ikb = ijkb0 + ih ps(ikb,ii) = ps(ikb,ii) + BB_(jkb,ii, ik1)*qq(ih,jh,nt) ENDDO ENDDO ENDDO ijkb0 = ijkb0+nh(nt) ENDIF ENDDO ELSE DO na = 1, nat IF ( ityp(na) == nt ) ijkb0 = ijkb0 + nh(nt) ENDDO ENDIF ENDDO DO ii=1,nkb ps(ii,ii) = ps(ii,ii) + (1.d0,0.d0) ENDDO CALL zinv_matrix(ps,nkb) BB_(:,:,ik1) = (0.d0,0.d0) ijkb0 = 0 DO nt=1,ntyp IF (upf(nt)%tvanp) THEN DO na=1,nat IF(ityp(na)==nt) THEN DO ii=1,nkb DO jh=1,nh(nt) jkb=ijkb0 + jh DO ih=1,nh(nt) ikb = ijkb0 + ih BB_(ii,jkb,ik1) = BB_(ii,jkb,ik1) - ps(ii,ikb)*qq(ih,jh,nt) ENDDO ENDDO ENDDO ijkb0 = ijkb0+nh(nt) ENDIF ENDDO ELSE DO na = 1, nat IF ( ityp(na) == nt ) ijkb0 = ijkb0 + nh(nt) ENDDO ENDIF ENDDO ENDDO DEALLOCATE(ps) ENDIF CALL init_us_2(npw_k(ik),igk_k(:,ik),xk(1,ik),vkb) !call ccalbec( nkb, lda, n, m, becp, vkb, psi ) CALL calbec(n,vkb,psi,becp,m) ! ALLOCATE( ps( nkb, m ) ) ps(:,:) = (0.d0,0.d0) ! DO ibnd=1,m DO jkb=1,nkb DO ii=1,nkb ps(jkb,ibnd) = ps(jkb,ibnd)+BB_(jkb,ii,ik)*becp%k(ii,ibnd) ENDDO ENDDO ENDDO ! ! CALL ZGEMM( 'N', 'N', n, m, nkb, (1.D0, 0.D0), vkb, & lda, ps, nkb, (1.D0, 0.D0), spsi, lda ) DEALLOCATE( ps ) ! RETURN ! END SUBROUTINE sm1_psi_k ! END SUBROUTINE sm1_psi ! !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! SUBROUTINE dinv_matrix(M,N) !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! USE kinds, ONLY : DP IMPLICIT NONE INTEGER :: N ! matrix dimension real(kind=dp), DIMENSION(0:N-1,0:N-1) :: M ! MAtrix to be inverted real(kind=dp), DIMENSION(:), ALLOCATABLE :: work INTEGER, DIMENSION(:), ALLOCATABLE :: ipiv INTEGER :: i,lwork,info INTEGER, SAVE :: lworkfact data lworkfact /64/ lwork = lworkfact*N ALLOCATE(ipiv(0:N-1)) ALLOCATE(work(1:lwork)) ! Factorize Matrix M CALL dgetrf( N, N, M, N, ipiv, info ) IF (info/=0) THEN CALL errore('dinv_matrix','error in dgetrf',info) ENDIF ! Invert Matrix CALL dgetri( N, M, N, ipiv, work, lwork, info ) IF (info/=0) THEN CALL errore('dinv_matrix','error in dgetri',info) ELSE lworkfact = int(work(1)/N) ENDIF DEALLOCATE(work) DEALLOCATE(ipiv) END SUBROUTINE dinv_matrix !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! SUBROUTINE zinv_matrix(M,N) !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! USE kinds, ONLY : DP IMPLICIT NONE INTEGER :: N ! matrix dimension COMPLEX(kind=dp), DIMENSION(0:N-1,0:N-1) :: M ! MAtrix to be inverted COMPLEX(kind=dp), DIMENSION(:), ALLOCATABLE :: work INTEGER, DIMENSION(:), ALLOCATABLE :: ipiv INTEGER :: i,lwork,info INTEGER, SAVE :: lworkfact data lworkfact /64/ lwork = lworkfact*N ALLOCATE(ipiv(0:N-1)) ALLOCATE(work(1:lwork)) ! Factorize Matrix M CALL zgetrf( N, N, M, N, ipiv, info ) IF (info/=0) THEN CALL errore('zinv_matrix','error in zgetrf',info) ENDIF ! Invert Matrix CALL zgetri( N, M, N, ipiv, work, lwork, info ) IF (info/=0) THEN CALL errore('zinv_matrix','error in zgetri',info) ELSE lworkfact = int(work(1)/N) ENDIF DEALLOCATE(work) DEALLOCATE(ipiv) END SUBROUTINE zinv_matrix TDDFPT/src/lr_diagonalise.f900000755000175000017500000001116112341371472014215 0ustar mbamba!----------------------------------------------------------------------- SUBROUTINE lr_diagonalise(iter) !--------------------------------------------------------------------- ! Brent Walker, ICTP, 2004 !--------------------------------------------------------------------- ! ... diagonalises the coefficient matrix from the Lanczos using ! ... LAPACK/BLAS routines !--------------------------------------------------------------------- ! ! USE io_global, ONLY : stdout USE kinds, ONLY : dp USE lr_variables, ONLY : lr_verbosity ! IMPLICIT NONE ! INTEGER,INTENT(in) :: iter ! INTEGER :: dimen real(kind=dp),ALLOCATABLE :: coeff_mat(:,:) ! dimen=2*iter ALLOCATE(coeff_mat(dimen,dimen)) coeff_mat(:,:)=0.0d0 CALL lr_build_matrix_spectrum(coeff_mat,iter) ! CALL lr_diagonalise_matrix(coeff_mat,dimen) ! DEALLOCATE(coeff_mat) ! RETURN END SUBROUTINE lr_diagonalise !----------------------------------------------------------------------- SUBROUTINE lr_diagonalise_matrix(coeff_mat,dimen) ! ! USE io_global, ONLY : stdout USE kinds, ONLY : dp USE lr_variables, ONLY : vl,vr,eval1,eval2 USE io_global, ONLY : stdout ! IMPLICIT NONE ! ! input variables INTEGER,INTENT(in) :: dimen real(kind=dp),INTENT(in) :: coeff_mat(dimen,dimen) ! ! local variables real(kind=dp),ALLOCATABLE :: work(:) INTEGER :: info INTEGER :: i,j real(kind=dp) :: temp1,temp2 real(kind=dp),ALLOCATABLE :: vl_temp(:),vr_temp(:) ! IF (lr_verbosity > 5) THEN WRITE(stdout,'("")') ENDIF IF(allocated(eval1)) DEALLOCATE(eval1) IF(allocated(eval2)) DEALLOCATE(eval2) IF(allocated(vl)) DEALLOCATE(vl) IF(allocated(vr)) DEALLOCATE(vr) ! ALLOCATE(eval1(dimen)) ALLOCATE(eval2(dimen)) ALLOCATE(vl(dimen,dimen)) ALLOCATE(vr(dimen,dimen)) eval1(:)=0.0d0 eval2(:)=0.0d0 vl(:,:)=0.0d0 vr(:,:)=0.0d0 ! ALLOCATE(work(8*dimen)) ALLOCATE(vl_temp(dimen),vr_temp(dimen)) work(:)=0.0d0 vl_temp(:)=0.0d0 vr_temp(:)=0.0d0 ! info=0 ! CALL dgeev('v','v',dimen,coeff_mat,dimen,eval1,eval2, & vl,dimen,vr,dimen,work,8*dimen,info) ! IF (info/=0) THEN CALL errore(' lr_main ', 'Diagonalisation of coefficient ' // & & 'matrix unsuccessful',1) ENDIF ! IF(.true.) THEN ! sort the eigenvalues (inefficient) DO i=1,dimen DO j=1,i IF(eval1(i)")') DO i=1,dimen WRITE(stdout,'(5X,i5,2(1X,f20.12))') i,eval1(i),eval2(i) ENDDO WRITE(stdout,'(5X,"# < end of eigenvalue listing >")') ! DEALLOCATE(work) DEALLOCATE(vl_temp) DEALLOCATE(vr_temp) ! RETURN ! END SUBROUTINE lr_diagonalise_matrix !----------------------------------------------------------------------- SUBROUTINE lr_build_matrix_spectrum(coeff_mat,iter) !--------------------------------------------------------------------- ! ... version for non-hermitian lanczos scheme !--------------------------------------------------------------------- ! ! USE io_global, ONLY : stdout USE kinds, ONLY : dp USE lr_variables, ONLY : a,b ! IMPLICIT NONE ! INTEGER,INTENT(in) :: iter real(kind=dp) :: coeff_mat(2*iter,2*iter) ! INTEGER :: i,j ! DO i=1,iter coeff_mat(i,i)=1.0d0 ENDDO coeff_mat(1,1)=0.0d0 coeff_mat(2,2)=0.0d0 coeff_mat(1,2)=a(1,1) coeff_mat(2,1)=a(2,1) ! trirecursion: DO i = 2, iter coeff_mat(2*i-1,2*i-1)=0.0d0 coeff_mat(2*i+0,2*i+0)=0.0d0 coeff_mat(2*i-1,2*i+0)=a(1,i) coeff_mat(2*i+0,2*i-1)=a(2,i) ! write(*,*) "A and B", i,"-th iteration" ! write(*,"(4f12.4)") a(1,i),a(2,i),b(1,i),b(2,i) ! write(*,*) "" coeff_mat(2*i-3,2*i-1)=b(1,i) coeff_mat(2*i-2,2*i+0)=b(2,i) coeff_mat(2*i-1,2*i-3)=abs(b(2,i)) coeff_mat(2*i+0,2*i-2)=abs(b(1,i)) ENDDO trirecursion ! IF(.false.) THEN DO i=1,2*iter DO j=1,2*iter WRITE(stdout,'(f10.5,$)') coeff_mat(i,j) ENDDO WRITE(stdout,*) ENDDO ENDIF ! RETURN END SUBROUTINE lr_build_matrix_spectrum !----------------------------------------------------------------------- TDDFPT/src/lr_solve_e.f900000755000175000017500000001655312341371472013404 0ustar mbamba! ! Copyright (C) 2001 PWSCF group ! This file is distributed under the terms of the ! GNU General Public License. See the file `License' ! in the root directory of the present distribution, ! or http://www.gnu.org/copyleft/gpl.txt . ! !------------------------------------------------------------------------- SUBROUTINE lr_solve_e !----------------------------------------------------------------------- ! ! bwalker: This routine is a driver for the solution of the linear ! bwalker: system which defines the change of the wavefunction ! bwalker: due to an electric field. ! bwalker: Calculates the initial starting vectors for use in the ! bwalker: block Lanczos. ! bwalker: We have to solve to find the action of the electric field ! bwalker: operator on the initial state. ! bwalker: Inspired by PHONON subroutine "solve_e". ! !----------------------------------------------------------------------- ! ! Modified by Osman Baris Malcioglu (2009) ! USE kinds, ONLY : dp USE gvect, ONLY : gstart USE io_global, ONLY : stdout USE io_files, ONLY : diropn, tmp_dir, wfc_dir USE klist, ONLY : nks, xk, degauss USE lr_variables, ONLY : nwordd0psi, iund0psi,LR_polarization, test_case_no USE lr_variables, ONLY : n_ipol, evc0, d0psi, evc1,lr_verbosity,d0psi_rs USE realus, ONLY : igk_k,npw_k USE lsda_mod, ONLY : lsda, isk, current_spin USE uspp, ONLY : vkb USE wvfct, ONLY : igk, nbnd, npwx, npw, et, current_k USE control_flags, ONLY : gamma_only USE wavefunctions_module, ONLY : evc USE mp_global, ONLY : inter_pool_comm, intra_bgrp_comm USE mp, ONLY : mp_max,mp_min,mp_barrier USE realus, ONLY : real_space, real_space_debug!, dvpsir_e USE control_ph, ONLY : alpha_pv ! IMPLICIT NONE ! ! counter on bands ! counter on k points ! counter on spins ! counter on polarizations INTEGER :: ibnd, ik, is, ip ! ! CHARACTER(len=6), EXTERNAL :: int_to_char LOGICAL :: exst real (kind=dp) :: anorm CHARACTER(len=256) :: tmp_dir_saved ! IF (lr_verbosity > 5) WRITE(stdout,'("")') ! CALL start_clock ('lr_solve_e') IF( lr_verbosity > 1 ) & WRITE(stdout,'(5X,"lr_solve_e: alpha_pv=",1X,e12.5)') alpha_pv DO ik=1,nks current_k=ik IF ( lsda ) current_spin = isk(ik) evc(:,:)=evc0(:,:,ik) npw=npw_k(ik) igk(:)=igk_k(:,ik) CALL init_us_2(npw,igk,xk(1,ik),vkb) ! Computes/reads P_c^+ x psi_kpoint into d0psi array IF ( n_ipol==3 ) THEN DO ip=1,3 CALL lr_dvpsi_e(ik,ip,d0psi(:,:,ik,ip)) ENDDO ELSEIF ( n_ipol==1 ) THEN CALL lr_dvpsi_e(ik,LR_polarization,d0psi(:,:,ik,1)) ENDIF ENDDO !endif ! IF (gstart == 2 .and. gamma_only) d0psi(1,:,:,:) = cmplx(dble(d0psi(1,:,:,:)),0.0d0,dp) !OBM!!! debug IF (test_case_no == 2) THEN PRINT *,"dumping d0psi" OPEN(UNIT=47,FILE="d0psi.dump",STATUS='NEW',ACCESS = 'SEQUENTIAL') WRITE(unit=47,FMT=*) "Kpoint --- band --- plane wave --- value for pol1 --- value for pol2 --- value for pol3" DO ik=1,nks DO ibnd=1,nbnd DO ip=1, npw WRITE(unit=47,FMT='(I3," ",2(I7," "), 3("(",E14.5," ",E14.5,"i)"))') ik, & ibnd, ip, d0psi(ip,ibnd,ik,1), d0psi(ip,ibnd,ik,3), d0psi(ip,ibnd,ik,3) ENDDO ENDDO ENDDO CLOSE(47) PRINT *, "dump complete" ENDIF !OBM!!! end of debug ! XC.Ge compute d0psi in real-space, will overwrite the d0psi calculated ! before if(d0psi_rs .eqv. .true.) call compute_d0psi_rs(n_ipol) ! Writing d0psi for restart nwordd0psi = 2 * nbnd * npwx * nks ! Reading of files: ! This is a parallel read, done in wfc_dir tmp_dir_saved = tmp_dir IF ( wfc_dir /= 'undefined' ) tmp_dir = wfc_dir DO ip = 1, n_ipol IF (n_ipol==1) CALL diropn ( iund0psi, 'd0psi.'//trim(int_to_char(LR_polarization)), nwordd0psi, exst) IF (n_ipol==3) CALL diropn ( iund0psi, 'd0psi.'//trim(int_to_char(ip)), nwordd0psi, exst) CALL davcio(d0psi(1,1,1,ip),nwordd0psi,iund0psi,1,1) CLOSE( UNIT = iund0psi) ENDDO ! End of file i/o tmp_dir = tmp_dir_saved CALL stop_clock ('lr_solve_e') WRITE(stdout,'(5X,"lr_wfcinit_spectrum: finished lr_solve_e")') RETURN contains !-------------------------------------------------------------------- SUBROUTINE compute_d0psi_rs( n_ipol ) !-------------------------------------------------------------------- ! ! ... original code from routine compute_dipole ! ... modified to calculate the d0psi in the real space ! ... by Xiaochuan Ge, Oct, 2013 ! USE kinds, ONLY : DP USE cell_base, ONLY : at, bg, alat, omega USE fft_base, ONLY : dfftp,dffts USE mp_global, ONLY : me_bgrp, intra_bgrp_comm use mp, only : mp_barrier use io_global, only : stdout USE wvfct, ONLY : nbnd,npwx use klist, only : nks use lr_variables, only : evc0,sevc0,d0psi use wavefunctions_module, only : psic use uspp, only : okvan use realus, only : bfft_orbital_gamma,fft_orbital_gamma ! IMPLICIT NONE ! ! ... Define variables complex(dp) :: wfck(npwx,1) ! ... Local variables REAL(DP),allocatable :: r(:,:) complex(dp),allocatable :: psic_temp(:) INTEGER :: i, j, k, ip, ir, ir_end, index0,ib,n_ipol REAL(DP) :: inv_nr1, inv_nr2, inv_nr3 if(.not. allocated(psic)) allocate(psic(dfftp%nnr)) allocate(psic_temp(dfftp%nnr)) allocate(r(dfftp%nnr,n_ipol)) ! ... Initialization write(stdout,'(5x,"Calculating d0psi in the real space."//)') if(okvan) then write(stdout,'(10x,"At this moment d0psi_rs is not available for USPP !!!",//)') #ifdef __MPI call mp_barrier(intra_bgrp_comm) ! call mp_stop(100) #endif stop endif ! Calculat r inv_nr1 = 1.D0 / DBLE( dfftp%nr1 ) inv_nr2 = 1.D0 / DBLE( dfftp%nr2 ) inv_nr3 = 1.D0 / DBLE( dfftp%nr3 ) #if defined (__MPI) index0 = dfftp%nr1x*dfftp%nr2x*SUM(dfftp%npp(1:me_bgrp)) ir_end = MIN(dfftp%nnr,dfftp%nr1x*dfftp%nr2x*dfftp%npp(me_bgrp+1)) #else index0 = 0 ir_end = dfftp%nnr #endif ! DO ir = 1, ir_end ! ! ... three dimensional indexes i = index0 + ir - 1 k = i / (dfftp%nr1x*dfftp%nr2x) i = i - (dfftp%nr1x*dfftp%nr2x)*k j = i / dfftp%nr1x i = i - dfftp%nr1x*j DO ip = 1, n_ipol r(ir,ip) = DBLE( i )*inv_nr1*at(ip,1) + & DBLE( j )*inv_nr2*at(ip,2) + & DBLE( k )*inv_nr3*at(ip,3) END DO enddo do ib = 1, nbnd wfck(:,1)=evc0(:,ib,1) call fft_orbital_gamma(wfck(:,:),1,1) psic_temp(:)=psic(:) DO ip = 1, n_ipol ! Apply dipole operator do ir = 1, dfftp%nnr psic(ir)=r(ir,ip)*alat*psic_temp(ir) enddo ! Convert to g space call bfft_orbital_gamma(wfck(:,:),1,1) d0psi(:,ib,1,ip)=wfck(:,1) enddo enddo ! orthogonalized batch orbitals to occupied minifold do ip = 1, n_ipol CALL lr_ortho(d0psi(:,:,:,ip), evc0(:,:,1), 1, 1, sevc0(:,:,1),.true.) enddo deallocate(r) deallocate(psic_temp) RETURN END SUBROUTINE compute_d0psi_rs !---------------------------------------------------------------------------- END SUBROUTINE lr_solve_e TDDFPT/src/lr_dav_routines.f900000644000175000017500000016344712341371472014454 0ustar mbamba!!---------------------------------------------------------------------------- module lr_dav_routines !---------------------------------------------------------------------------- ! Created by Xiaochuan Ge (Oct, 2012) !----------------------------------------------------------------------- contains subroutine lr_dav_cvcouple() !----------------------------------------------------------------------- ! Created by Xiaochuan Ge (Oct, 2012) !----------------------------------------------------------------------- ! This subroutine returns num_init couples of occ/virt states to be used ! as the initial vectors of lr davidson algorithm use kinds, only : dp use wvfct, only : nbnd, nbndx, et use lr_dav_variables, only : vc_couple,num_init,single_pole,energy_dif,& & energy_dif_order, p_nbnd_occ, p_nbnd_virt,& & if_dft_spectrum use lr_variables, only : nbnd_total use io_global, only : stdout use lr_dav_debug implicit none integer :: ib,ic,iv real(dp) :: temp allocate(vc_couple(2,nbnd*(nbnd_total-nbnd))) ! 1. v 2. c allocate(energy_dif(p_nbnd_occ*p_nbnd_virt)) allocate(energy_dif_order(p_nbnd_occ*p_nbnd_virt)) if(.not. if_dft_spectrum) & &write(stdout,'(5x,"Calculating the electron-hole pairs for initiating trial vectors ...",/)') if(single_pole) then write(stdout,'(/5x,"Single Pole Approximation is used to generate the initial vectors",/)') write(stdout,'(/5x,"At this moment, this movement is only valid for NC PPs, and ecut_rho=4*ecut_wfc.",/5x, & "Please make sure that you are using the correct input",/)') endif ib=0 do iv = nbnd-p_nbnd_occ+1, nbnd do ic = nbnd+1, nbnd+p_nbnd_virt ib = ib+1 energy_dif(ib)=(et(ic,1)-et(iv,1)) if(single_pole) then temp = calc_inter(iv,ic,iv,ic) energy_dif(ib) = energy_dif(ib) + temp endif enddo enddo call xc_sort_array_get_order(energy_dif,p_nbnd_occ*p_nbnd_virt,energy_dif_order) do ib=1, p_nbnd_occ*p_nbnd_virt iv=energy_dif_order(ib) vc_couple(1,ib)=((iv-1)/p_nbnd_virt)+1+(nbnd-p_nbnd_occ) vc_couple(2,ib)=mod((iv-1),p_nbnd_virt)+nbnd+1 write(stdout,'(10x,3(I5,5x),F20.12)') ib,vc_couple(1,ib), vc_couple(2,ib)-nbnd, energy_dif(energy_dif_order(ib)) enddo write(stdout,'(5x,"Finished calculating the cv couples.")') RETURN END subroutine lr_dav_cvcouple !------------------------------------------------------------------------------- subroutine lr_dav_alloc_init() !--------------------------------------------------------------------- ! Created by X.Ge in Oct.2012 !--------------------------------------------------------------------- ! Allocates and initialises variables for lr_davidson algorithm use lr_dav_variables use lr_variables, only : nbnd_total use wvfct, only : nbnd,npwx use klist, only : nks use uspp, only : okvan use io_global, only : stdout implicit none integer :: ierr write(stdout,'(5x,"Num of eigen values=",I15)') num_eign write(stdout,'(5x,"Allocating parameters for davidson ...")') call estimate_ram() !allocate(D_vec_b(npwx,nbnd,nks,num_basis_max),stat=ierr) !IF (ierr /= 0) call errore('lr_dav_alloc_init',"no enough memory",ierr) !allocate(C_vec_b(npwx,nbnd,nks,num_basis_max),stat=ierr) !IF (ierr /= 0) call errore('lr_dav_alloc_init',"no enough memory",ierr) allocate(svecwork(npwx,nbnd,nks)) allocate(vecwork(npwx,nbnd,nks)) allocate(M(num_basis_max,num_basis_max)) allocate(M_shadow_avatar(num_basis_max,num_basis_max)) allocate(M_C(num_basis_max,num_basis_max)) allocate(M_D(num_basis_max,num_basis_max)) allocate(left_M(num_basis_max,num_basis_max)) allocate(right_M(num_basis_max,num_basis_max)) allocate(left_full(npwx,nbnd,nks,num_eign)) allocate(right_full(npwx,nbnd,nks,num_eign)) allocate(right_res(npwx,nbnd,nks,num_eign)) allocate(left_res(npwx,nbnd,nks,num_eign)) allocate(right2(num_eign)) allocate(left2(num_eign)) allocate(eign_value(num_basis_max,2)) allocate(tr_energy(num_basis_max)) allocate(eign_value_order(num_basis_max)) allocate(kill_left(num_eign)) allocate(kill_right(num_eign)) allocate(ground_state(npwx,nbnd,nks)) allocate(omegal(num_eign)) allocate(omegar(num_eign)) allocate(inner_matrix(num_basis_max,num_basis_max)) allocate(chi_dav(3,num_eign)) allocate(total_chi(num_eign)) allocate(Fx(nbnd,nbnd_total-nbnd)) allocate(Fy(nbnd,nbnd_total-nbnd)) lwork=8*num_basis_max allocate(work(lwork)) allocate(vec_b(npwx,nbnd,nks,num_basis_max),stat=ierr) ! subspace basises IF (ierr /= 0) call errore('lr_dav_alloc_init',"no enough memory",ierr) if( .not. poor_of_ram .and. okvan ) then write(stdout,'(5x,"poor_of_ram is set to .false.. This means that you & &would like to increase the speed of",/5x,"your calculation with& & USPP by paying double memory.",/5x,"Switch it to .true. if you need & &to save memory.",/)') allocate(svec_b(npwx,nbnd,nks,num_basis_max),stat=ierr) IF (ierr /= 0) call errore('lr_dav_alloc_init',"no enough memory",ierr) endif if( .not. poor_of_ram2 ) then write(stdout,'(5x,"poor_of_ram2 is set to .false.. This means that you & &would like to increase the speed ",/5x,"by storing the D_basis& & and C_basis vectors which will cause three time of the memory cost.",& /5x,"Switch it to .true. if you need & &to save memory.",/)') allocate(D_vec_b(npwx,nbnd,nks,num_basis_max),stat=ierr) IF (ierr /= 0) call errore('lr_dav_alloc_init',"no enough memory",ierr) allocate(C_vec_b(npwx,nbnd,nks,num_basis_max),stat=ierr) IF (ierr /= 0) call errore('lr_dav_alloc_init',"no enough memory",ierr) endif if ( p_nbnd_occ > nbnd ) p_nbnd_occ = nbnd if ( p_nbnd_virt > nbnd_total-nbnd ) p_nbnd_virt = nbnd_total-nbnd if ( p_nbnd_occ*p_nbnd_virt .lt. num_init .and. .not. if_random_init) then write(stdout,'(/5X,"Initial vectors are forced to be chosen & &randomly because no enough particle-hole pairs are available.",/5x, & "You may want to try to calculate more virtual states or include more occupied states by changing & p_nbnd_occ in the input.",/)') if_random_init=.true. ! The only way to set initial state when there's no virtual state. endif write(stdout,'(5x,"Finished allocating parameters.")') return end subroutine lr_dav_alloc_init !------------------------------------------------------------------------------- subroutine lr_dav_set_init() !--------------------------------------------------------------------- ! Created by X.Ge in Jan.2013 !--------------------------------------------------------------------- ! This routine use the cvcouple and the dft wavefunction to set the ! initial sub space use kinds, only : dp use wvfct, only : nbnd, npwx, et use lr_dav_variables use lr_variables, only : evc0, sevc0 ,revc0, evc0_virt,& & sevc0_virt, nbnd_total,davidson use io_global, only : stdout use wvfct, only : g2kin,npwx,nbnd,et,npw use gvect, only : gstart use uspp, only : okvan use lr_us use lr_dav_debug implicit none integer :: ib,ia,ipw,ibnd real(dp) :: temp,R,R2 write(stdout,'(5x,"Initiating variables for davidson ...")') ! set initial basis num_basis=num_init num_basis_tot=num_init vec_b(:,:,:,:) = (0.0D0,0.0D0) if (.not. if_random_init .or. if_dft_spectrum) then ! set the initial basis set to be {|c>abs(array(sort_order(ia))-reference)) THEN temp_order=sort_order(ia) sort_order(ia)=sort_order(ib) sort_order(ib)=temp_order endif enddo enddo RETURN END subroutine xc_sort_array_get_order !------------------------------------------------------------------------------- subroutine dav_calc_residue() !------------------------------------------------------------------------------- ! Created by X.Ge in Jan. 2013 !------------------------------------------------------------------------------- ! Calculate the residue of appro. eigen vector use lr_dav_variables, only : right_res,left_res,svecwork,C_vec_b,D_vec_b,& kill_left,kill_right,poor_of_ram2,right2,left2,& right_full,left_full,eign_value_order,residue_conv_thr,& toadd,left_M,right_M,num_eign,dav_conv,num_basis,zero,max_res use lr_variables, only : evc0, sevc0 use kinds, only : dp use io_global, only : stdout use wvfct, only : nbnd, npwx, npw use lr_dav_debug use lr_us implicit none integer :: ieign, flag,ibr complex(kind=dp) :: temp(npwx,nbnd) max_res=0 kill_left(:)=.false. kill_right(:)=.false. toadd=2*num_eign call start_clock("calc_residue") do ieign = 1, num_eign if(poor_of_ram2) then ! If D_ C_ basis are not stored, we have to apply liouvillian again call lr_apply_liouvillian(right_full(:,:,:,ieign),right_res(:,:,:,ieign),svecwork(:,:,:),.true.) ! Apply lanczos call lr_apply_liouvillian(left_full(:,:,:,ieign),left_res(:,:,:,ieign),svecwork(:,:,:),.false.) call lr_ortho(right_res(:,:,:,ieign), evc0(:,:,1), 1,1,sevc0(:,:,1),.true.) ! Project to virtual space call lr_ortho(left_res(:,:,:,ieign), evc0(:,:,1), 1,1,sevc0(:,:,1),.true.) else ! Otherwise they are be recovered directly by the combination of C_ and D_ basis left_res(:,:,:,ieign)=0.0d0 right_res(:,:,:,ieign)=0.0d0 do ibr = 1, num_basis right_res(:,:,1,ieign)=right_res(:,:,1,ieign)+right_M(ibr,eign_value_order(ieign))*C_vec_b(:,:,1,ibr) left_res(:,:,1,ieign)=left_res(:,:,1,ieign)+left_M(ibr,eign_value_order(ieign))*D_vec_b(:,:,1,ibr) enddo endif ! The reason of useing this method call lr_1to1orth(right_res(1,1,1,ieign),left_full(1,1,1,ieign)) call lr_1to1orth(left_res(1,1,1,ieign),right_full(1,1,1,ieign)) ! Instead of this will be explained in the document ! right_res(:,:,:,ieign)=right_res(:,:,:,ieign)-sqrt(eign_value(eign_value_order(ieign),1))*left_full(:,:,:,ieign) ! left_res(:,:,:,ieign)=left_res(:,:,:,ieign)-sqrt(eign_value(eign_value_order(ieign),1))*right_full(:,:,:,ieign) ! Update kill_r/l right2(ieign)=lr_dot_us(right_res(1,1,1,ieign),right_res(1,1,1,ieign)) if (abs(aimag(right2(ieign))) .gt. zero .or. dble(right2(ieign)) .lt. 0.0D0) then write(stdout,'(7x,"Warning! Wanging! the residue is weird.")') endif if( dble(right2(ieign)) .lt. residue_conv_thr ) then kill_right(ieign)=.true. toadd=toadd-1 endif if( dble(right2(ieign)) .gt. max_res ) max_res = dble(right2(ieign)) left2(ieign)=lr_dot_us(left_res(1,1,1,ieign),left_res(1,1,1,ieign)) if (abs(aimag(left2(ieign))) .gt. zero .or. dble(left2(ieign)) .lt. 0.0D0) then write(stdout,'(7x,"Warning! Wanging! the residue is weird.")') endif if( dble(left2(ieign)) .lt. residue_conv_thr ) then kill_left(ieign)=.true. toadd=toadd-1 endif if( dble(left2(ieign)) .gt. max_res ) max_res = dble(left2(ieign)) write (stdout,'(5x,"Residue(Squared modulus):",I5,2x,2F15.7)') ieign, dble(right2(ieign)), dble(left2(ieign)) enddo write(stdout,'(7x,"Largest residue:",5x,F20.12)') max_res if(max_res .lt. residue_conv_thr) dav_conv=.true. call stop_clock("calc_residue") return end subroutine dav_calc_residue !------------------------------------------------------------------------------- subroutine dav_expan_basis() !------------------------------------------------------------------------------- ! Created by X.Ge in Jan. 2013 !------------------------------------------------------------------------------- use lr_dav_variables use lr_variables, only : evc0, sevc0 use io_global, only : stdout use uspp, only : okvan use lr_us use lr_dav_debug implicit none integer :: ieign, flag real (dp) :: temp if(dav_conv) return ! Already converged call start_clock("expan_basis") if (precondition) then do ieign = 1, num_eign if(.not. kill_left(ieign)) then call treat_residue(left_res(:,:,1,ieign),ieign) call lr_norm(left_res(1,1,1,ieign)) call lr_ortho(left_res(:,:,:,ieign), evc0(:,:,1), 1, 1,sevc0(:,:,1),.true.) call lr_norm(left_res(1,1,1,ieign)) endif if(.not. kill_right(ieign)) then call treat_residue(right_res(:,:,1,ieign),ieign) call lr_norm(right_res(1,1,1,ieign)) call lr_ortho(right_res(:,:,:,ieign), evc0(:,:,1), 1, 1,sevc0(:,:,1),.true.) call lr_norm(left_res(1,1,1,ieign)) endif enddo endif ! Here mGS are called three times and lr_ortho is called once for increasing ! numerical stability of orthonalization call lr_mGS_orth() ! 1st call lr_mGS_orth_pp() call lr_mGS_orth() ! 2nd call lr_mGS_orth_pp() call lr_mGS_orth() ! 3rd call lr_mGS_orth_pp() do ieign = 1, num_eign call lr_ortho(right_res(:,:,:,ieign), evc0(:,:,1), 1, 1,sevc0(:,:,1),.true.) call lr_ortho(left_res(:,:,:,ieign), evc0(:,:,1), 1, 1,sevc0(:,:,1),.true.) call lr_norm(right_res(:,:,:,ieign)) call lr_norm(left_res(:,:,:,ieign)) enddo if(toadd .eq. 0) then write(stdout,'("TOADD is zero !!")') dav_conv=.true. return endif !if( dav_iter .gt. max_iter .or. num_basis+toadd .gt. num_basis_max ) then if( dav_iter .gt. max_iter ) then write(stdout,'(/5x,"!!!! We have arrived maximum number of iterations. We have to stop & &here, and the result will not be trustable !!!!! ")') dav_conv=.true. else num_basis_old=num_basis if(num_basis+toadd .gt. num_basis_max) call discharge_temp() num_basis_tot=num_basis_tot+toadd ! Expand the basis do ieign = 1, num_eign if(.not. kill_left(ieign)) then num_basis=num_basis+1 vec_b(:,:,:,num_basis)=left_res(:,:,:,ieign) if(.not. poor_of_ram .and. okvan) & call lr_apply_s(vec_b(:,:,:,num_basis),svec_b(:,:,:,num_basis)) endif if(.not. kill_right(ieign)) then num_basis=num_basis+1 vec_b(:,:,:,num_basis)=right_res(:,:,:,ieign) if(.not. poor_of_ram .and. okvan) & call lr_apply_s(vec_b(:,:,:,num_basis),svec_b(:,:,:,num_basis)) endif enddo endif if(conv_assistant) then if(max_res .lt. 10*residue_conv_thr .and. .not. ploted(1)) then call interpret_eign('10') ploted(1)=.true. endif endif call stop_clock("expan_basis") return end subroutine dav_expan_basis !------------------------------------------------------------------------------- subroutine lr_mGS_orth() !------------------------------------------------------------------------------- ! Created by X.Ge in Jan. 2013 !------------------------------------------------------------------------------- ! Modified GS algorithm to ortholize the new basis respect to the old basis use kinds, only : dp use klist, only : nks use wvfct, only : npwx,nbnd use uspp, only : okvan use lr_dav_variables implicit none integer :: ib,ieign,ieign2,ia real(dp) :: temp call start_clock("mGS_orth") ! first orthogonalize to old basis do ib = 1, num_basis do ieign = 1, num_eign if (.not. kill_left(ieign)) then if(poor_of_ram .or. .not. okvan) then ! Less memory needed call lr_1to1orth(left_res(1,1,1,ieign),vec_b(1,1,1,ib)) else ! Less calculation, double memory required call lr_bi_1to1orth(left_res(1,1,1,ieign),vec_b(1,1,1,ib),svec_b(1,1,1,ib)) endif endif if (.not. kill_right(ieign)) then if(poor_of_ram .or. .not. okvan) then ! Less memory needed call lr_1to1orth(right_res(1,1,1,ieign),vec_b(1,1,1,ib)) else ! Less calculation, double memory required call lr_bi_1to1orth(right_res(1,1,1,ieign),vec_b(1,1,1,ib),svec_b(1,1,1,ib)) endif endif enddo enddo ! orthogonalize between new basis themselves do ieign = 1, num_eign if (.not. kill_left(ieign) .and. .not. kill_right(ieign)) then call lr_1to1orth(left_res(1,1,1,ieign),right_res(1,1,1,ieign)) endif do ieign2 = ieign+1, num_eign if (.not. kill_left(ieign2) .and. .not. kill_left(ieign)) & call lr_1to1orth(left_res(1,1,1,ieign2),left_res(1,1,1,ieign)) if (.not. kill_left(ieign2) .and. .not. kill_right(ieign)) & call lr_1to1orth(left_res(1,1,1,ieign2),right_res(1,1,1,ieign)) if (.not. kill_right(ieign2) .and. .not. kill_left(ieign)) & call lr_1to1orth(right_res(1,1,1,ieign2),left_res(1,1,1,ieign)) if (.not. kill_right(ieign2) .and. .not. kill_right(ieign)) & call lr_1to1orth(right_res(1,1,1,ieign2),right_res(1,1,1,ieign)) enddo enddo call stop_clock("mGS_orth") return end subroutine lr_mGS_orth !------------------------------------------------------------------------------- subroutine lr_mGS_orth_pp() !------------------------------------------------------------------------------- ! Created by X.Ge in Jan. 2013 !------------------------------------------------------------------------------- ! After MGS, this pp routine try to exclude duplicate vectors and then ! normalize the rest use kinds, only : dp use klist, only : nks use wvfct, only : npwx,nbnd use io_global, only : stdout use lr_dav_variables use lr_us implicit none integer :: ieign,ia real(dp) :: norm_res call start_clock("mGS_orth_pp") do ieign = 1, num_eign if(.not. kill_left(ieign)) then norm_res = dble(lr_dot_us(left_res(1,1,1,ieign),left_res(1,1,1,ieign))) if(norm_res .lt. residue_conv_thr) then kill_left(ieign) = .true. write(stdout,'("One residue is eliminated:",5x,E20.12)') norm_res toadd=toadd-1 else call lr_norm(left_res(:,:,1,ieign)) endif endif if(.not. kill_right(ieign)) then norm_res = dble(lr_dot_us(right_res(1,1,1,ieign),right_res(1,1,1,ieign))) if(norm_res .lt. residue_conv_thr) then kill_right(ieign) = .true. write(stdout,'("One residue is eliminated:",5x,E20.12)') norm_res toadd=toadd-1 else call lr_norm(right_res(:,:,1,ieign)) endif endif enddo call stop_clock("mGS_orth_pp") return end subroutine lr_mGS_orth_pp !------------------------------------------------------------------------------- subroutine lr_norm(vect) !------------------------------------------------------------------------------- ! Created by X.Ge in Jan. 2013 !------------------------------------------------------------------------------- ! Normalizes vect, returns vect/sqrt() use kinds, only : dp use klist, only : nks use wvfct, only : npwx,nbnd use lr_us implicit none complex(dp) :: vect(npwx,nbnd,nks),svect(npwx,nbnd,nks) real(dp) :: temp temp=dble(lr_dot_us(vect(1,1,1),vect(1,1,1))) vect(:,:,:)=vect(:,:,:)/sqrt(temp) return end subroutine lr_norm !------------------------------------------------------------------------------- subroutine lr_1to1orth(vect1,vect2) !------------------------------------------------------------------------------- ! Created by X.Ge in Jan. 2013 !------------------------------------------------------------------------------- ! This routine calculate the components of vect1 which is "vertical" to ! vect2 use kinds, only : dp use klist, only : nks use wvfct, only : npwx,nbnd,npw use lr_us implicit none complex(dp) :: vect1(npwx,nbnd,nks),vect2(npwx,nbnd,nks) vect1(:,:,1)=vect1(:,:,1)-(lr_dot_us(vect1(1,1,1),vect2(1,1,1))/lr_dot_us(vect2(1,1,1),vect2(1,1,1)))*vect2(:,:,1) return end subroutine lr_1to1orth !------------------------------------------------------------------------------- subroutine lr_bi_1to1orth(vect1,vect2,svect2) ! Created by X.Ge in Jun. 2013 !------------------------------------------------------------------------------- ! This routine calculate the components of vect1 which is "vertical" to ! vect2. In the case of USPP, svect2 is explicitly treated as input so one ! dose need to spend time calculating it use kinds, only : dp use klist, only : nks use wvfct, only : npwx,nbnd,npw implicit none complex(kind=dp),external :: lr_dot complex(dp) :: vect1(npwx,nbnd,nks),vect2(npwx,nbnd,nks),svect2(npwx,nbnd,nks) vect1(:,:,1)=vect1(:,:,1)-(lr_dot(svect2(1,1,1),vect1(1,1,1))/lr_dot(svect2(1,1,1),vect2(1,1,1)))*vect2(:,:,1) return end subroutine lr_bi_1to1orth !------------------------------------------------------------------------------- subroutine treat_residue(vect,ieign) !------------------------------------------------------------------------------- ! Created by X.Ge in Jan. 2013 !------------------------------------------------------------------------------- ! This routine apply pre-condition to the residue to speed up the ! convergence use kinds, only : dp use wvfct, only : g2kin,npwx,nbnd,et,npw use lr_dav_variables, only : reference, diag_of_h, tr_energy,eign_value_order,& &turn2planb use g_psi_mod implicit none complex(dp) :: vect(npwx,nbnd) integer :: ia,ib,ieign,flag real(dp) :: temp,minimum minimum=0.0001d0 do ib = 1, nbnd do ia = 1, npw temp = g2kin(ia)-et(ib,1)-reference if( abs(temp) .lt. minimum ) temp = sign(minimum,temp) vect(ia,ib) = vect(ia,ib)/temp enddo enddo return end subroutine treat_residue !------------------------------------------------------------------------------- subroutine interpret_eign(message) !------------------------------------------------------------------------------- ! Created by X.Ge in Jan. 2013 !------------------------------------------------------------------------------- ! This routine try to interpret physical information from the solution of ! casider's equation use kinds, only : dp use lr_variables, only : evc0, sevc0,R, nbnd_total,evc0_virt use lr_dav_variables use charg_resp, only : lr_calc_R use wvfct, only : nbnd use io_global, only : stdout,ionode,ionode_id use mp, only : mp_bcast,mp_barrier use mp_world, only : world_comm use lr_us implicit none character(len=*) :: message integer :: ieign, ia,ic,iv,ipol real(kind=dp), external :: ddot real(dp) :: norm, normx, normy, alpha, shouldbe1,temp real(dp) :: C_right_M(num_basis_max),D_left_M(num_basis_max) if(.not. allocated(norm_F)) allocate(norm_F(num_eign)) if(message=="END") then write(stdout,'(/7x,"================================================================")') write(stdout,'(/7x,"Davidson diagonalization has finished in",I5," steps.")') dav_iter write(stdout,'(10x,"the number of current basis is",I5)') num_basis write(stdout,'(10x,"the number of total basis built is",I5)') num_basis_tot write(stdout,'(/7x,"Now print out information of eigenstates")') endif if(message=="10")& write(stdout,'(/7x,"Quasi convergence(10*residue_conv_thr) has been arrived in",I5," steps.")') dav_iter if(.not. done_calc_R) then call lr_calc_R() done_calc_R=.true. endif ! Print out Oscilation strength if(message == "END") then write(stdout,'(/,/5x,"K-S Oscillator strengths")') write(stdout,'(5x,"occ",1x,"con",8x,"R-x",14x,"R-y",14x,"R-z")') do iv=nbnd-p_nbnd_occ+1, nbnd do ic=1,p_nbnd_virt write(stdout,'(5x,i3,1x,i3,3x,E16.8,2X,E16.8,2X,E16.8)') & &iv,ic,dble(R(iv,ic,1)),dble(R(iv,ic,2)),dble(R(iv,ic,3)) enddo enddo endif ! Analysis of each eigen-state do ieign = 1, num_eign #ifdef __MPI ! This part is calculated in serial if(ionode) then #endif ia = eign_value_order(ieign) if(message=="END")& write(stdout,'(/7x,"! The",I5,1x,"-th eigen state. The transition& & energy is: ", 5x, F12.8)') ieign, tr_energy(ia) ! Please see Documentation for the explain of the next four steps ! In short it gets the right components of X and Y ! Apply C to the right eigen state in order to calculate the right omega call dgemv('N',num_basis,num_basis,(1.0D0,0.0D0),dble(M_C),& &num_basis_max,right_M(:,ia),1,(0.0D0,0.0D0),C_right_M,1) omegar(ieign)=ddot(num_basis,left_M(:,ia),1,left_M(:,ia),1) omegar(ieign)=ddot(num_basis,C_right_M,1,left_M(:,ia),1) ! Apply D to the left eigen state in order to calculate the left omega call dgemv('N',num_basis,num_basis,(1.0D0,0.0D0),dble(M_D),& &num_basis_max,left_M(:,ia),1,(0.0D0,0.0D0),D_left_M,1) omegal(ieign)=ddot(num_basis,right_M(:,ia),1,right_M(:,ia),1) omegal(ieign)=ddot(num_basis,D_left_M,1,right_M(:,ia),1) if(abs(omegal(ieign)*omegar(ieign)-tr_energy(ia)**2) .gt. zero) then write(stdout,'(/5x,"Warning !!! : The interpretation of the eigenstates may have problems.")') write(stdout,'(10x,"omegal*omegar = ",F20.12,10x,"omega^2 = ",F20.12)') & &omegal(ieign)*omegar(ieign),tr_energy(ia)**2 endif ! scale right_full and left_full in order to make omegar = omegal omegar(ieign)=sqrt(dble(omegar(ieign))) omegal(ieign)=sqrt(dble(omegal(ieign))) #ifdef __MPI endif call mp_barrier(world_comm) call mp_bcast(omegar,ionode_id,world_comm) call mp_bcast(omegal,ionode_id,world_comm) #endif right_full(:,:,:,ieign)=right_full(:,:,:,ieign)/dble(omegar(ieign)) left_full(:,:,:,ieign)=left_full(:,:,:,ieign)/dble(omegal(ieign)) ! Normalize the vector norm=2.0d0*dble(lr_dot_us(right_full(1,1,1,ieign),left_full(1,1,1,ieign))) norm=sqrt(abs(norm)) right_full(:,:,:,ieign)=right_full(:,:,:,ieign)/norm left_full(:,:,:,ieign)=left_full(:,:,:,ieign)/norm ! Linear transform from L,R back to x,y left_res(:,:,:,ieign)=(right_full(:,:,:,ieign)+left_full(:,:,:,ieign))/sqrt(2.0d0) !X right_res(:,:,:,ieign)=(right_full(:,:,:,ieign)-left_full(:,:,:,ieign))/sqrt(2.0d0) !Y normx=dble(lr_dot_us(left_res(1,1,1,ieign),left_res(1,1,1,ieign))) normy=-dble(lr_dot_us(right_res(1,1,1,ieign),right_res(1,1,1,ieign))) norm_F(ieign)=normx+normy !! Actually norm_F should always be one since it was previously normalized if(message=="END") then write(stdout,'(/5x,"The two digitals below indicate the importance of doing beyong TDA: ")') write(stdout,'(/5x,"Components: X",2x,F12.5,";",4x,"Y",2x,F12.5)') & normx/norm_F(ieign),normy/norm_F(ieign) endif call lr_calc_Fxy(ieign) normx=0 normy=0 do iv = nbnd-p_nbnd_occ+1, nbnd do ic = 1, p_nbnd_virt normx=normx+Fx(iv,ic)*Fx(iv,ic) normy=normy-Fy(iv,ic)*Fy(iv,ic) enddo enddo if( normx+normy .lt. 0.0d0 ) then normx=-normx normy=-normy endif if(message=="END") then write (stdout,'(/5x,"In the occ-virt project subspace the total Fxy is:")') write(stdout,'(/5x,"X",2x,F12.5,";",4x,"Y",2x,F12.5,4x,"total",2x,F12.5,2x,& &"/ ",F12.5)') normx,normy,normx+normy,norm_F(ieign) endif do ipol = 1 ,3 chi_dav(ipol,ieign)=dav_calc_chi("X",ieign,ipol)+dav_calc_chi("Y",ieign,ipol) chi_dav(ipol,ieign)=chi_dav(ipol,ieign)*chi_dav(ipol,ieign)*2.0d0/(PI*3) enddo total_chi(ieign)=chi_dav(1,ieign)+chi_dav(2,ieign)+chi_dav(3,ieign) if(message=="END") then write (stdout,'(/5x,"The Chi_i_i is",5x,"Total",10x,"1",15x,"2",15x,"3")') write (stdout,'(/12x,8x,E15.8,3x,E15.8,3x,E15.8,3x,E15.8)') total_chi(ieign),& &chi_dav(1,ieign),chi_dav(2,ieign), chi_dav(3,ieign) ! Components analysis write (stdout,'(/5x,"Now is the components analysis of this transition.")') call print_principle_components() write (stdout,'(/5x,"Now for all the calculated particle and hole pairs : ")') write (stdout,'(/5x,"occ",5x,"virt",7x,"FX",14x,"FY",/)') do iv = nbnd-p_nbnd_occ+1, nbnd do ic = 1, p_nbnd_virt write (stdout,'(3x,I5,I5,5x,E15.8,5x,E15.8)') iv, ic, dble(Fx(iv,ic)), dble(Fy(iv,ic)) enddo enddo write(stdout,'(/7x,"**************",/)') endif enddo #ifdef __MPI if(ionode) then #endif call write_eigenvalues(message) call write_spectrum(message) #ifdef __MPI endif #endif return end subroutine interpret_eign !------------------------------------------------------------------------------- real(dp) function dav_calc_chi(flag_calc,ieign,ipol) !------------------------------------------------------------------------------- ! Created by X.Ge in Feb. 2013 !------------------------------------------------------------------------------- ! This routine calculates the CHi from the igenvector use lr_dav_variables use lr_variables, only : d0psi use kinds, only : dp use lr_us implicit none character :: flag_calc integer :: ieign,ipol if( flag_calc .eq. "X" ) then dav_calc_chi=lr_dot_us(d0psi(:,:,1,ipol), left_res(:,:,1,ieign)) else if (flag_calc .eq. "Y") then dav_calc_chi=lr_dot_us(d0psi(:,:,1,ipol), right_res(:,:,1,ieign)) endif return end function dav_calc_chi !------------------------------------------------------------------------------- subroutine write_spectrum(message) !------------------------------------------------------------------------------- ! Created by X.Ge in Feb. 2013 !------------------------------------------------------------------------------- ! write the spectrum to ${prefix}.plot file use lr_dav_variables use io_files, only : prefix use kinds, only : dp use io_global, only : stdout implicit none character(len=*) :: message character(len=256) :: filename integer :: ieign, nstep, istep real(dp) :: frequency real(dp), allocatable :: absorption(:,:) Write(stdout,'(5x,"Now generate the spectrum plot file...")') if(message=="END") filename = trim(prefix) // ".plot" if(message=="10") filename = trim(prefix) // ".plot-quasi-conv" OPEN(17,file=filename,status="unknown") write(17,'("#",2x,"Energy(Ry)",10x,"total",13x,"X",13x,"Y",13x,"Z")') write(17,'("# Broadening is: ",5x,F10.7,5x"Ry")') broadening nstep=(finish-start)/step+1 allocate(absorption(nstep,5)) ! Column 1: Energy; 2: Toal; 3,4,5: X,Y,Z absorption(:,:)=0.0d0 frequency=start istep=1 do while( .not. istep .gt. nstep ) absorption(istep,1)=frequency do ieign = 1,num_eign absorption(istep,2)=absorption(istep,2)+total_chi(ieign)*& &func_broadening(frequency-tr_energy(eign_value_order(ieign))) absorption(istep,3)=absorption(istep,3)+chi_dav(1,ieign)*& &func_broadening(frequency-tr_energy(eign_value_order(ieign))) absorption(istep,4)=absorption(istep,4)+chi_dav(2,ieign)*& &func_broadening(frequency-tr_energy(eign_value_order(ieign))) absorption(istep,5)=absorption(istep,5)+chi_dav(3,ieign)*& &func_broadening(frequency-tr_energy(eign_value_order(ieign))) enddo write(17,'(5E20.8)') absorption(istep,1),absorption(istep,1)*absorption(istep,2),& absorption(istep,1)*absorption(istep,3),absorption(istep,1)*& absorption(istep,4),absorption(istep,1)*absorption(istep,5) istep=istep+1 frequency=frequency+step enddo deallocate(absorption) close(17) return end subroutine write_spectrum !------------------------------------------------------------------------------- real(dp) function func_broadening(delta) !------------------------------------------------------------------------------- ! Created by X.Ge in Feb. 2013 !------------------------------------------------------------------------------- ! Calculate the broadening with the energy diff use kinds, only : dp use lr_dav_variables, only : broadening implicit none real(dp) :: delta func_broadening = broadening/(delta**2+broadening**2) return end function func_broadening !------------------------------------------------------------------------------- subroutine print_principle_components() !------------------------------------------------------------------------------- ! Created by X.Ge in Feb. 2013 !------------------------------------------------------------------------------- ! Print out the principle transition use lr_dav_variables use wvfct, only : nbnd use kinds, only : dp use lr_variables, only : nbnd_total,R use io_global, only : stdout implicit none integer :: iv, ic real(dp) :: temp write (stdout,'(/5x,"First we print out only the principle components.")') write (stdout,'(/5x,"occ",5x,"virt",7x,"FX",14x,"FY"/)') do iv = nbnd-p_nbnd_occ+1, nbnd do ic = 1, p_nbnd_virt temp = Fx(iv,ic)*Fx(iv,ic)+Fy(iv,ic)*Fy(iv,ic) if(temp .gt. 0.01) then write (stdout,'(3x,I5,I5,5x,F10.5,5x,F10.5,5x,F10.5)') iv,ic, dble(Fx(iv,ic)), dble(Fy(iv,ic)) !write (stdout,'(5x,"R 1,2,3",3F10.5)'), dble(R(iv,ic,1)),dble(R(iv,ic,2)),dble(R(iv,ic,3)) endif enddo enddo end subroutine print_principle_components !------------------------------------------------------------------------------- real(dp) function calc_inter(v1,c1,v2,c2) !------------------------------------------------------------------------------- ! Created by X.Ge in Jan. 2013 !------------------------------------------------------------------------------- ! calculate the interaction between two electron-hole pairs use kinds, only : DP use wvfct, only : nbnd,et use lr_dav_variables use lr_variables, only : evc0, sevc0 ,revc0, evc0_virt use wvfct, only : npwx,wg use fft_base, only : dffts,dfftp use uspp, only : okvan use io_global, only : stdout use realus, only : fft_orbital_gamma, bfft_orbital_gamma use wavefunctions_module, only : psic use cell_base, only : omega use mp, only : mp_barrier use mp_world, only : world_comm implicit none integer :: v1,c1,v2,c2,ia,ir complex(dp) :: wfck(npwx,1) complex(dp), allocatable :: dvrss(:),wfcr(:),dvrs(:) real(dp) :: w1,temp real(kind=dp), external :: ddot ALLOCATE( psic(dfftp%nnr) ) ALLOCATE( dvrss(dffts%nnr) ) !ALLOCATE( dvrs(dfftp%nnr) ) if(okvan) then write(stdout,'(10x,"At this moment single-pole is not available for USPP !!!",//)') #ifdef __MPI call mp_barrier( world_comm ) call errore(" "," ", 100) #endif stop endif w1=wg(v1,1)/omega wfck(:,1) = evc0(:,v1,1) call fft_orbital_gamma(wfck(:,:),1,1) ! FFT: v1 -> psic dvrss(:) = psic(:) ! v1 -> dvrss wfck(:,1) = evc0_virt(:,c1-nbnd,1) call fft_orbital_gamma(wfck(:,:),1,1) ! FFT: c1 -> psic do ir = 1, dffts%nnr dvrss(ir) = w1 * dvrss(ir) * psic(ir) ! drho = 2*v1*c1 -> dvrss enddo call dv_of_drho(0,dvrss,.false.) ! calc the potential change wfck(:,1) = evc0(:,v2,1) call fft_orbital_gamma(wfck(:,:),1,1) ! FFT: v2 -> psic do ir = 1, dffts%nnr psic(ir) = psic(ir) * dvrss(ir) ! dv*v2 -> psic enddo call bfft_orbital_gamma(wfck(:,:),1,1) ! BFFT: dv*v2 -> wfck calc_inter = wfc_dot(wfck(:,1),evc0_virt(:,c2-nbnd,1)) deallocate(psic) deallocate(dvrss) return end function calc_inter !------------------------------------------------------------------------------- real(dp) function wfc_dot(x,y) !------------------------------------------------------------------------------- ! Created by X.Ge in Jan. 2013 !------------------------------------------------------------------------------- ! calculate the inner product between two wfcs use kinds, only : dp use wvfct, only : npwx, npw use lr_dav_variables use gvect, only : gstart use mp_global, only : intra_bgrp_comm use mp, only : mp_sum, mp_barrier use mp_world, only : world_comm implicit none real(kind=dp), external :: ddot complex(dp) :: x(npwx), y (npwx) integer :: i wfc_dot=2.D0*ddot(2*npw,x(:),1,y(:),1) if(gstart==2) wfc_dot=wfc_dot-dble(x(1))*dble(y(1)) #ifdef __MPI call mp_barrier(world_comm) call mp_sum(wfc_dot,intra_bgrp_comm) #endif return end function wfc_dot !------------------------------------------------------------------------------- subroutine lr_calc_Fxy(ieign) !------------------------------------------------------------------------------- ! Created by X.Ge in Jan. 2013 !------------------------------------------------------------------------------- ! This routine calculates the Fx and Fy for the ieign-th eigen vector use wvfct, only : nbnd use lr_variables, only : nbnd_total,evc0,sevc0_virt,R use lr_dav_variables implicit none integer :: ic,iv, ieign real(dp) :: sum_F do iv = nbnd-p_nbnd_occ+1, nbnd do ic = 1, p_nbnd_virt Fx(iv,ic)=wfc_dot(left_res(:,iv,1,ieign),sevc0_virt(:,ic,1))/sqrt(norm_F(ieign)) Fy(iv,ic)=wfc_dot(right_res(:,iv,1,ieign),sevc0_virt(:,ic,1))/sqrt(norm_F(ieign)) enddo enddo end subroutine lr_calc_Fxy !------------------------------------------------------------------------------- subroutine random_init() !------------------------------------------------------------------------------- ! Created by X.Ge in May. 2013 !------------------------------------------------------------------------------- ! This routine initiate basis set with radom vectors use kinds, only : dp use wvfct, only : g2kin,npwx,nbnd,et,npw use gvect, only : gstart use klist, only : nks use io_global, only : stdout use uspp, only : okvan use lr_variables, only : evc0, sevc0 use lr_us use lr_dav_variables implicit none integer :: ia, ib, ibnd, ipw real(dp) :: temp,R,R2 write(stdout,'(5x,"Preconditional random vectors are used as initial vectors ...")') do ib = 1, num_init do ibnd = 1, nbnd do ipw = 1, npw call random_number(R) call random_number(R2) !apply precondition temp = g2kin(ipw)-et(ibnd,1)-reference if( abs(temp) .lt. 0.001d0 ) temp = sign(0.001d0,temp) vec_b(ipw,ibnd,1,ib)=cmplx(R,R2)/temp enddo if(gstart==2) vec_b(1,ibnd,1,ib)=& &cmplx(dble(vec_b(1,ibnd,1,ib)),0.0d0) ! Gamma point wfc must be real at g=0 enddo call lr_norm(vec_b(1,1,1,ib)) ! For increase numerical stability enddo ! Orthogonalize to occupied states do ib = 1, num_init call lr_ortho(vec_b(:,:,:,ib), evc0(:,:,1), 1, 1,sevc0(:,:,1),.true.) call lr_norm(vec_b(1,1,1,ib)) enddo ! GS orthogonalization, twice for numerical stability ! 1st do ib = 1, num_init call lr_norm(vec_b(1,1,1,ib)) do ia = ib+1, num_init call lr_1to1orth(vec_b(1,1,1,ia),vec_b(1,1,1,ib)) enddo enddo ! 2nd do ib = 1, num_init call lr_norm(vec_b(1,1,1,ib)) do ia = ib+1, num_init call lr_1to1orth(vec_b(1,1,1,ia),vec_b(1,1,1,ib)) enddo if(.not. poor_of_ram .and. okvan) & &call lr_apply_s(vec_b(:,:,1,ib),svec_b(:,:,1,ib)) enddo return end subroutine random_init !------------------------------------------------------------------------------- subroutine write_eigenvalues(message) !------------------------------------------------------------------------------- ! Created by X.Ge in Feb. 2013 !------------------------------------------------------------------------------- ! write the eigenvalues and their oscilator strength use lr_dav_variables use io_files, only : prefix use kinds, only : dp use io_global, only : stdout implicit none character(len=*) :: message character(len=256) :: filename integer :: ieign Write(stdout,'(5x,"Now generate the eigenvalues list...")') if(message=="END") filename = trim(prefix) // ".eigen" if(message=="10") filename = trim(prefix) // ".eigen-quasi-conv" OPEN(18,file=filename,status="unknown") write(18,'("#",2x,"Energy(Ry)",10x,"total",13x,"X",13x,"Y",13x,"Z")') do ieign=1, num_eign write(18,'(5E20.8)') tr_energy(eign_value_order(ieign)),total_chi(ieign),& chi_dav(1,ieign),chi_dav(2,ieign),chi_dav(3,ieign) enddo close(18) return end subroutine write_eigenvalues !------------------------------------------------------------------------------- subroutine estimate_ram() !------------------------------------------------------------------------------- ! Created by X.Ge in Jun. 2013 !------------------------------------------------------------------------------- use lr_dav_variables use kinds, only : dp use uspp, only : okvan use io_global, only : stdout use wvfct, only : nbnd,npwx use klist, only : nks implicit none real(dp) :: ram_vect, ram_eigen if( .not. poor_of_ram .and. okvan ) then ram_vect=2.0d0*sizeof(ram_vect)*nbnd*npwx*nks*num_basis_max*2 else ram_vect=2.0d0*sizeof(ram_vect)*nbnd*npwx*nks*num_basis_max endif if(.not. poor_of_ram2)& &ram_vect=ram_vect+2.0d0*sizeof(ram_vect)*nbnd*npwx*nks*num_basis_max*2 ram_eigen=2.0d0*sizeof(ram_eigen)*nbnd*npwx*nks*num_eign*4 write(stdout,'(/5x,"Estimating the RAM requirements:")') write(stdout,'(10x,"For the basis sets:",5x,F10.2,5x,"M")') ram_vect/1048576 write(stdout,'(10x,"For the eigenvectors:",5x,F10.2,5x,"M")') ram_eigen/1048576 write(stdout,'(10x,"Num_eign =",5x,I5,5x,"Num_basis_max =",5x,I5)') num_eign,num_basis_max write(stdout,'(5x,"Do make sure that you have enough RAM.",/)') return end subroutine estimate_ram !------------------------------------------------------------------------------- subroutine discharge_temp() !------------------------------------------------------------------------------- ! Created by X.Ge in Jun. 2013 !------------------------------------------------------------------------------- ! This routine discharges the basis set keeping only 2*num_eign best vectors for the ! basis and through aways others in order to make space for the new vectors use lr_dav_variables use kinds, only : dp use uspp, only : okvan use io_global, only : stdout use wvfct, only : nbnd,npwx use klist, only : nks use lr_us implicit none integer :: ieign,ib,ia write(stdout,'(/5x,"!!!! The basis set has arrived its maximum size, now discharge it",/5x,& &"to make space for the following calculation.")') ! Set the new vec_b and s_vec_b do ieign = 1, num_eign vec_b(:,:,:,2*ieign-1)=right_full(:,:,:,ieign) vec_b(:,:,:,2*ieign)=left_full(:,:,:,ieign) enddo ! GS orthogonalization, twice for numerical stability ! 1st do ib = 1, 2*num_eign call lr_norm(vec_b(1,1,1,ib)) do ia = ib+1, num_init call lr_1to1orth(vec_b(1,1,1,ia),vec_b(1,1,1,ib)) enddo enddo ! 2nd do ib = 1, 2*num_eign call lr_norm(vec_b(1,1,1,ib)) do ia = ib+1, num_init call lr_1to1orth(vec_b(1,1,1,ia),vec_b(1,1,1,ib)) enddo if(.not. poor_of_ram .and. okvan) & &call lr_apply_s(vec_b(:,:,1,ib),svec_b(:,:,1,ib)) enddo if(.not. poor_of_ram .and. okvan) then do ieign = 1 , 2*num_eign call lr_apply_s(vec_b(:,:,:,ieign),svec_b(:,:,:,ieign)) enddo endif num_basis_old=0 num_basis=2*num_eign return end subroutine discharge_temp !------------------------------------------------------------------------------- subroutine discharge() !------------------------------------------------------------------------------- ! Created by X.Ge in Jun. 2013 !------------------------------------------------------------------------------- ! This routine discharges the basis set keeping only 2*num_eign best vectors for the ! basis and through aways others in order to make space for the new vectors use lr_dav_variables use kinds, only : dp use uspp, only : okvan use io_global, only : stdout use wvfct, only : nbnd,npwx use klist, only : nks use lr_us implicit none integer :: ieign,ibr write(stdout,'(/5x,"!!!! The basis set has arrived its maximum size, now discharge it",/5x,& &"to make space for the following calculation.")') ! Set the new vec_b and s_vec_b do ieign = 1, num_eign vec_b(:,:,:,2*ieign-1)=right_full(:,:,:,ieign) vec_b(:,:,:,2*ieign)=left_full(:,:,:,ieign) call lr_apply_s(vec_b(:,:,:,2*ieign-1),svec_b(:,:,:,2*ieign-1)) call lr_apply_s(vec_b(:,:,:,2*ieign),svec_b(:,:,:,2*ieign)) enddo ! If needed set the new D_vec_b and C_vec_b if(.not. poor_of_ram2) then right_full(:,:,:,:)=0.0d0 left_full(:,:,:,:)=0.0d0 do ieign = 1, num_eign do ibr = 1, num_basis left_full(:,:,1,ieign)=left_full(:,:,1,ieign)+left_M(ibr,eign_value_order(ieign))*vec_b(:,:,1,ibr) right_full(:,:,1,ieign)=right_full(:,:,1,ieign)+right_M(ibr,eign_value_order(ieign))*vec_b(:,:,1,ibr) enddo enddo endif left_res(:,:,:,ieign)=0.0d0 right_res(:,:,:,ieign)=0.0d0 do ibr = 1, num_basis right_res(:,:,1,ieign)=right_res(:,:,1,ieign)+right_M(ibr,eign_value_order(ieign))*C_vec_b(:,:,1,ibr) left_res(:,:,1,ieign)=left_res(:,:,1,ieign)+left_M(ibr,eign_value_order(ieign))*D_vec_b(:,:,1,ibr) enddo return end subroutine discharge !------------------------------------------------------------------------------- subroutine dft_spectrum() !------------------------------------------------------------------------------- ! Created by X.Ge in Aug. 2013 !------------------------------------------------------------------------------- ! This routine calculates the dft_spectrum(KS_spectrum), of which the energy ! of the peak is the KS energy difference and the oscillation strength is ! energy*|R_ij|^2 use kinds, only : dp use wvfct, only : nbnd, nbndx, et use lr_dav_variables, only : vc_couple,num_init,single_pole,energy_dif,& & energy_dif_order, p_nbnd_occ, p_nbnd_virt,PI use lr_variables, only : nbnd_total,R use charg_resp, only : lr_calc_R use io_global, only : stdout,ionode use io_files, only : prefix use lr_dav_debug implicit none integer :: ib,ic,iv,i real(dp) :: energy,totF,F1,F2,F3 character(len=256) :: filename write(stdout,'(/,/5x,"Calculating the KS spectrum ..."/)') call lr_dav_cvcouple() ! First calculate the cv couple and sort the energy !difference call lr_calc_R() ! Calculate R #ifdef __MPI if(ionode) then #endif ! Print out Oscilation strength write(stdout,'(/,/5x,"K-S Oscillator strengths")') write(stdout,'(5x,"occ",1x,"con",8x,"R-x",14x,"R-y",14x,"R-z")') do iv=nbnd-p_nbnd_occ+1, nbnd do ic=1,p_nbnd_virt write(stdout,'(5x,i3,1x,i3,3x,E16.8,2X,E16.8,2X,E16.8)') & &iv,ic,dble(R(iv,ic,1)),dble(R(iv,ic,2)),dble(R(iv,ic,3)) enddo enddo ! Print out to standard output and eigen-file filename = trim(prefix) // "-dft.eigen" OPEN(18,file=filename,status="unknown") write(18,'("#",2x,"Energy(Ry)",10x,"total",13x,"X",13x,"Y",13x,"Z")') write(stdout,'(5x,"The peaks of KS spectrum and their strength are:")') write(stdout,'("#",5x,"occ",5x,"virt",5x,"Energy(Ry)",10x,"total",13x,"X",13x,"Y",13x,"Z")') do ib=1, p_nbnd_occ*p_nbnd_virt energy=energy_dif(energy_dif_order(ib)) iv=vc_couple(1,ib) ic=vc_couple(2,ib)-nbnd F1=dble(R(iv,ic,1))**2*2/(PI*3) F2=dble(R(iv,ic,2))**2*2/(PI*3) F3=dble(R(iv,ic,3))**2*2/(PI*3) totF=F1+F2+F3 write(18,'(5E20.8)') energy,totF,F1,F2,F3 write(stdout,'(2I5,5E15.5)') iv,ic,energy,totF,F1,F2,F3 enddo #ifdef __MPI endif #endif CALL clean_pw( .false. ) WRITE(stdout,'(5x,"Finished KS spectrum calculation...")') CALL stop_clock('lr_dav_main') CALL print_clock_lr() CALL stop_lr( .false. ) end subroutine dft_spectrum END MODULE lr_dav_routines TDDFPT/src/lr_write_restart.f900000755000175000017500000001213212341371472014633 0ustar mbamba! ! Copyright (C) 2004-2013 Quantum ESPRESSO group ! This file is distributed under the terms of the ! GNU General Public License. See the file `License' ! in the root directory of the present distribution, ! or http://www.gnu.org/copyleft/gpl.txt . ! !-------------------------------------------------------------------- SUBROUTINE lr_write_restart() !--------------------------------------------------------------------- ! ... reads in and stores the vectors necessary to ! ... restart the Lanczos recursion !--------------------------------------------------------------------- ! ! Modified by Osman Baris Malcioglu (2009) ! Modified by Xiaochuan Ge (May. 2013) to adapt pseudo-hermitian ! USE io_files, ONLY : tmp_dir, prefix, diropn USE lr_variables, ONLY : beta_store, gamma_store, zeta_store, norm0, & LR_polarization, LR_iteration, n_ipol,F,project,& evc1,evc1_new,evc1_old,iunrestart, nwordrestart, & nbnd_total, charge_response,lr_verbosity,& bgz_suffix USE charg_resp, ONLY : resonance_condition, rho_1_tot, rho_1_tot_im USE wvfct, ONLY : nbnd, npwx, npw USE fft_base, ONLY : dfftp USE io_global, ONLY : ionode USE klist, ONLY : nks USE noncollin_module, ONLY : nspin_mag USE io_global, ONLY : stdout ! IMPLICIT NONE ! CHARACTER(len=6), EXTERNAL :: int_to_char ! !integer, intent(in) :: pol, iter ! ! local variables ! INTEGER :: i, j, pol_index,ibnd_occ,ibnd_virt CHARACTER(len=256) :: tempfile, filename LOGICAL :: exst ! IF (lr_verbosity > 5) THEN WRITE(stdout,'("")') ENDIF ! !ionode only operations: ! Note: ionode only operations are carried out in tmp_dir not wfc_dir ! pol_index=1 !if there is only one polarization dir, storage is one rank less IF ( n_ipol /= 1 ) pol_index=LR_polarization #ifdef __MPI IF (ionode) THEN #endif ! !Writing beta gamma and zeta ! ! filename = trim(prefix) // trim(bgz_suffix) // trim(int_to_char(LR_polarization)) tempfile = trim(tmp_dir) // trim(filename) ! ! OPEN (158, file = tempfile, form = 'formatted', status = 'unknown') ! WRITE(158,*) LR_iteration ! norm0(pol_index)=beta_store(pol_index,1) WRITE(158,*) norm0(pol_index) ! DO i=1,LR_iteration-1 ! WRITE(158,*) beta_store(pol_index,i+1) WRITE(158,*) gamma_store(pol_index,i+1) !This is absolutely necessary for cross platform compatibilty DO j=1,n_ipol WRITE(158,*) zeta_store (pol_index,j,i) ENDDO ! ENDDO ! XC: compatable with the old version. The beta&gamma will not be used in ! spectrum calculation WRITE(158,*) beta_store(pol_index,LR_iteration) WRITE(158,*) gamma_store(pol_index,LR_iteration) DO j=1,n_ipol WRITE(158,*) zeta_store (pol_index,j,LR_iteration) ENDDO ! CLOSE(158) ! !Writing F ! IF (project) THEN filename = trim(prefix) // ".projection." // trim(int_to_char(LR_polarization)) tempfile = trim(tmp_dir) // trim(filename) ! ! OPEN (158, file = tempfile, form = 'formatted', status = 'unknown') ! WRITE(158,*) LR_iteration ! WRITE(158,*) nbnd !number of filled bands ! WRITE(158,*) nbnd_total !total number of bands ! DO ibnd_occ=1,nbnd DO ibnd_virt=1,(nbnd_total-nbnd) WRITE(158,*) F(ibnd_occ,ibnd_virt,pol_index) ENDDO ENDDO ! CLOSE(158) ENDIF ! #ifdef __MPI ENDIF #endif ! ! Parallel writing operations ! ! Note: Restart files are writen in outdir, if you do not want them to be ! written just disable restart saving completely ! ! ! Writing wavefuncion files for restart ! ! nwordrestart = 2 * nbnd * npwx * nks ! CALL diropn ( iunrestart, 'restart_lanczos.'//trim(int_to_char(LR_polarization)), nwordrestart, exst) ! CALL davcio(evc1(:,:,:,1),nwordrestart,iunrestart,1,1) CALL davcio(evc1(:,:,:,2),nwordrestart,iunrestart,2,1) CALL davcio(evc1_old(:,:,:,1),nwordrestart,iunrestart,3,1) CALL davcio(evc1_old(:,:,:,2),nwordrestart,iunrestart,4,1) ! CLOSE( unit = iunrestart) ! ! Writing charge response density for restart ! IF (charge_response == 1 ) THEN IF (resonance_condition) THEN CALL diropn ( iunrestart, 'restart_lanczos-rho_tot.'//trim(int_to_char(LR_polarization)), 2*dfftp%nnr*nspin_mag, exst) CALL davcio(rho_1_tot_im(:,:),2*dfftp%nnr*nspin_mag,iunrestart,1,1) CLOSE( unit = iunrestart) ELSE CALL diropn ( iunrestart, 'restart_lanczos-rho_tot.'//trim(int_to_char(LR_polarization)), 2*dfftp%nnr*nspin_mag, exst) CALL davcio(rho_1_tot(:,:),2*dfftp%nnr*nspin_mag,iunrestart,1,1) CLOSE( unit = iunrestart) ENDIF ENDIF ! RETURN END SUBROUTINE lr_write_restart !----------------------------------------------------------------------- TDDFPT/src/bcast_lr_input.f900000755000175000017500000001054712341371472014260 0ustar mbamba! ! Copyright (C) 2001-2003 PWSCF group ! This file is distributed under the terms of the ! GNU General Public License. See the file `License' ! in the root directory of the present distribution, ! or http://www.gnu.org/copyleft/gpl.txt . ! !----------------------------------------------------------------------- SUBROUTINE bcast_lr_input !----------------------------------------------------------------------- ! ! The first processor sends the input to all the other processors ! ! ! Modified by Osman Baris Malcioglu in 2009 #ifdef __MPI USE lr_variables USE lr_dav_variables USE realus, ONLY: real_space, real_space_debug USE mp, ONLY: mp_bcast, mp_barrier USE io_files, ONLY: tmp_dir, prefix, wfc_dir USE control_flags, ONLY: tqr, tddfpt USE charg_resp, ONLY: omeg, w_T_prefix, w_T_npol,epsil USE io_global, ONLY: ionode, ionode_id USE mp_global, ONLY: intra_image_comm USE mp_world, ONLY: world_comm USE exx, ONLY: ecutfock #ifdef __ENVIRON USE plugin_flags, ONLY: use_environ USE environ_input, ONLY: environ_bcast #endif IMPLICIT NONE ! ! ! CALL mp_barrier(world_comm) CALL mp_bcast (lr_io_level, ionode_id, world_comm ) CALL mp_bcast (itermax, ionode_id, world_comm ) CALL mp_bcast (itermax_int, ionode_id, world_comm ) CALL mp_bcast (charge_response, ionode_id, world_comm ) CALL mp_bcast (project, ionode_id, world_comm ) CALL mp_bcast (restart, ionode_id, world_comm ) CALL mp_bcast (restart_step, ionode_id, world_comm ) CALL mp_bcast (lr_verbosity, ionode_id, world_comm ) CALL mp_bcast (prefix, ionode_id, world_comm ) CALL mp_bcast (tmp_dir, ionode_id, world_comm ) CALL mp_bcast (wfc_dir, ionode_id, world_comm ) CALL mp_bcast (LR_polarization, ionode_id, world_comm ) CALL mp_bcast (ltammd, ionode_id, world_comm ) CALL mp_bcast (pseudo_hermitian, ionode_id, world_comm ) CALL mp_bcast (real_space, ionode_id, world_comm ) CALL mp_bcast (real_space_debug, ionode_id, world_comm ) CALL mp_bcast (tqr, ionode_id, world_comm ) CALL mp_bcast (test_case_no, ionode_id, world_comm ) CALL mp_bcast (omeg, ionode_id, world_comm ) CALL mp_bcast (epsil, ionode_id, world_comm ) CALL mp_bcast (w_T_prefix, ionode_id, world_comm ) CALL mp_bcast (w_T_npol, ionode_id, world_comm ) CALL mp_bcast (n_ipol, ionode_id, world_comm ) CALL mp_bcast (plot_type, ionode_id, world_comm ) CALL mp_bcast (no_hxc, ionode_id, world_comm ) CALL mp_bcast (bgz_suffix, ionode_id, world_comm ) call mp_bcast (scissor, ionode_id, world_comm) CALL mp_bcast (ecutfock, ionode_id, world_comm ) CALL mp_bcast (d0psi_rs, ionode_id,world_comm ) CALL mp_bcast (tddfpt, ionode_id, world_comm ) CALL plugin_arguments_bcast(ionode_id, world_comm) #ifdef __ENVIRON IF (use_environ) CALL environ_bcast() #endif ! for lr_dav CALL mp_bcast (davidson, ionode_id, world_comm ) CALL mp_bcast (num_eign, ionode_id, world_comm ) CALL mp_bcast (num_init, ionode_id, world_comm ) CALL mp_bcast (num_basis_max, ionode_id, world_comm ) CALL mp_bcast (residue_conv_thr, ionode_id, world_comm ) CALL mp_bcast (precondition, ionode_id, world_comm ) CALL mp_bcast (dav_debug, ionode_id, world_comm ) CALL mp_bcast (reference, ionode_id, world_comm ) CALL mp_bcast (single_pole, ionode_id, world_comm ) CALL mp_bcast (sort_contr, ionode_id, world_comm ) CALL mp_bcast (diag_of_h, ionode_id, world_comm ) CALL mp_bcast (close_pre, ionode_id, world_comm ) CALL mp_bcast (broadening, ionode_id, world_comm ) CALL mp_bcast (print_spectrum, ionode_id, world_comm ) CALL mp_bcast (start, ionode_id, world_comm ) CALL mp_bcast (finish, ionode_id, world_comm ) CALL mp_bcast (step, ionode_id, world_comm ) CALL mp_bcast (if_check_orth, ionode_id, world_comm ) CALL mp_bcast (if_random_init, ionode_id, world_comm ) CALL mp_bcast (if_check_her, ionode_id, world_comm ) CALL mp_bcast (p_nbnd_occ, ionode_id, world_comm ) CALL mp_bcast (p_nbnd_virt, ionode_id, world_comm ) CALL mp_bcast (poor_of_ram, ionode_id, world_comm ) CALL mp_bcast (poor_of_ram2, ionode_id, world_comm ) CALL mp_bcast (max_iter, ionode_id, world_comm ) CALL mp_bcast (conv_assistant, ionode_id, world_comm ) CALL mp_bcast (if_dft_spectrum, ionode_id, world_comm ) CALL mp_barrier(world_comm) #endif RETURN END SUBROUTINE bcast_lr_input TDDFPT/src/lr_read_wf.f900000755000175000017500000004151312341371472013351 0ustar mbamba!----------------------------------------------------------------------- SUBROUTINE lr_read_wf() !--------------------------------------------------------------------- ! ... reads in and stores the ground state wavefunctions ! ... for use in Lanczos linear response calculation !--------------------------------------------------------------------- ! ! Modified by Osman Baris Malcioglu (2009) ! Modified by Xiaochuan Ge (2013) to fix some bugs of virt_read and include davidson USE kinds, ONLY : dp USE io_global, ONLY : stdout USE klist, ONLY : nks, xk USE cell_base, ONLY : tpiba2 USE gvect, ONLY : ngm, g USE io_files, ONLY : nwordwfc, iunwfc, prefix, diropn,& & tmp_dir, wfc_dir USE lr_variables, ONLY : evc0, sevc0 ,revc0, evc0_virt,& & sevc0_virt, nbnd_total, becp1_virt, & & becp1_c_virt, no_hxc USE realus, ONLY : igk_k,npw_k USE lr_variables, ONLY : becp1, becp1_c, test_case_no,& & size_evc, project USE wvfct, ONLY : npw, igk, nbnd, g2kin, npwx, ecutwfc USE control_flags, ONLY : gamma_only,io_level USE gvecs, ONLY : nls, nlsm USE fft_base, ONLY : dffts USE fft_interfaces, ONLY : invfft USE uspp, ONLY : vkb, nkb, okvan USE becmod, ONLY : bec_type, becp, calbec USE realus, ONLY : real_space, fft_orbital_gamma,& & initialisation_level,& & bfft_orbital_gamma, calbec_rs_gamma,& & add_vuspsir_gamma, v_loc_psir,& & s_psir_gamma, real_space_debug USE lr_variables, ONLY : lr_verbosity, lr_exx, davidson USE buffers, ONLY : get_buffer USE exx, ONLY : exx_grid_init, exx_div_check, exx_restart USE funct, ONLY : dft_is_hybrid USE lr_exx_kernel, ONLY : lr_exx_revc0_init, lr_exx_alloc USE wavefunctions_module, ONLY : evc USE buffers, ONLY : open_buffer ! IMPLICIT NONE ! ! ! ! local variables INTEGER :: ik, ibnd, ig, itmp1,itmp2,itmp3 LOGICAL :: exst CHARACTER(len=256) :: filename, tmp_dir_saved !OBM debug real(kind=dp) :: obm_debug COMPLEX(kind=dp),EXTERNAL :: lr_dot ! IF (lr_verbosity > 5) THEN WRITE(stdout,'("")') ENDIF call start_clock("read_wf") ! IF ((nbnd_total>nbnd .and. davidson) .OR. project) THEN CALL virt_read() ELSE CALL normal_read() ENDIF WRITE(stdout,'(5x,"Finished reading wfc.")') evc(:,:)=evc0(:,:,1) IF ( dft_is_hybrid() ) THEN CALL open_buffer ( iunwfc, 'wfc', nwordwfc, io_level, exst ) CALL exx_grid_init() CALL exx_div_check() CALL exx_restart(.true.) IF(.NOT. no_hxc) THEN lr_exx =.TRUE. CALL lr_exx_alloc() DO ik=1,nks CALL lr_exx_revc0_init(evc0,ik) ENDDO ENDIF ENDIF WRITE(stdout,'(5x,"Finished exx setting.")') ! call stop_clock("read_wf") RETURN ! CONTAINS !----------------------------------------------------------------------- SUBROUTINE normal_read() ! ! The usual way of reading wavefunctions ! USE lr_variables, ONLY : check_all_bands_gamma, & & check_density_gamma, & & check_vector_gamma, tg_revc0 USE wavefunctions_module, ONLY : psic USE realus, ONLY : tg_psic USE mp_global, ONLY : me_bgrp ! ! IMPLICIT NONE ! LOGICAL :: use_tg INTEGER :: v_siz, incr, ioff, j WRITE( stdout, '(/5x,"Normal read")' ) use_tg=dffts%have_task_groups nwordwfc = nbnd * npwx size_evc=npwx*nbnd*nks incr = 2 ! ! Read in the ground state wavefunctions ! This is a parallel read, done in wfc_dir ! tmp_dir_saved = tmp_dir !IF ( wfc_dir /= 'undefined' ) tmp_dir = wfc_dir wfc_dir = tmp_dir CALL diropn ( iunwfc, 'wfc', 2*nwordwfc, exst) ! IF (.NOT.exst .AND. wfc_dir == 'undefined') CALL errore(& &'lr_read_wfc', TRIM( prefix )//'.wfc'//' not found',1) ! IF (.NOT.exst .AND. wfc_dir /= 'undefined') THEN ! WRITE( stdout, '(/5x,"Attempting to read wfc from outdir & &instead of wfcdir")' ) CLOSE( UNIT = iunwfc) ! tmp_dir = tmp_dir_saved ! CALL diropn ( iunwfc, 'wfc', 2*nwordwfc, exst) ! IF (.NOT.exst) CALL errore('lr_read_wfc', & &TRIM( prefix )//'.wfc'//' not found',1) ENDIF ! IF (gamma_only) THEN WRITE( stdout, '(/5x,"Gamma point algorithm")' ) ELSE WRITE( stdout, '(/5x,"Generalised algorithm !warning")' ) ENDIF ! DO ik=1,nks ! IF (.NOT. real_space_debug > 0 ) THEN !else done in init_realspace realus CALL gk_sort( xk(1,ik), ngm, g, ( ecutwfc / tpiba2 ), npw,& & igk, g2kin ) ! npw_k(ik) = npw ! igk_k(:,ik) = igk(:) ENDIF ! ! Read in the ground state wavefunctions ! This is a parallel read, done in wfc_dir CALL davcio(evc0(:,:,ik),2*nwordwfc,iunwfc,ik,-1) ! ENDDO ! ! CLOSE( UNIT = iunwfc) ! ! End of file reading ! tmp_dir = tmp_dir_saved ! ! ! vkb * evc0 and initialization of sevc0 ! ! IF ( okvan ) THEN ! IF ( gamma_only ) THEN ! ! Following line is to be removed when real space ! implementation is complete CALL init_us_2(npw,igk_k(:,1),xk(1,1),vkb) ! IF (real_space_debug>0) THEN ! ! DO ibnd=1,nbnd,2 CALL fft_orbital_gamma(evc0(:,:,1),ibnd,nbnd) CALL calbec_rs_gamma(ibnd,nbnd,becp1) becp%r(:,ibnd)=becp1(:,ibnd) IF (ibnd + 1 <= nbnd) becp%r(:,ibnd+1)=becp1(:,ibnd+1) CALL s_psir_gamma(ibnd,nbnd) CALL bfft_orbital_gamma(sevc0(:,:,1),ibnd,nbnd) ENDDO ! ELSE ! CALL calbec(npw_k(1),vkb,evc0(:,:,1),becp1) ! becp%r=becp1 ! CALL s_psi(npwx, npw_k(1), nbnd, evc0(:,:,1), sevc0(:,:,1)) ! ENDIF ELSE ! ! K point generalized stuff starts here ! DO ik=1,nks ! CALL init_us_2(npw_k(ik),igk_k(1,ik),xk(1,ik),vkb) ! CALL calbec(npw_k(ik),vkb,evc0(:,:,ik),becp1_c(:,:,ik)) ! becp%k=becp1_c(:,:,ik) ! CALL s_psi (npwx, npw_k(ik), nbnd, evc0(:,:,ik), & & sevc0(:,:,ik)) ! ENDDO ! ENDIF ! ELSE ! sevc0=evc0 ! ENDIF ! ! ! Inverse fourier transform of evc0 ! ! IF( dffts%have_task_groups ) THEN ! v_siz = dffts%tg_nnr * dffts%nogrp ! incr = 2 * dffts%nogrp ! tg_revc0=(0.0d0,0.0d0) ! ELSE ! revc0=(0.0d0,0.0d0) ! ENDIF ! IF ( gamma_only ) THEN ! ! DO ibnd=1,nbnd,incr ! CALL fft_orbital_gamma ( evc0(:,:,1), ibnd, nbnd) ! IF (dffts%have_task_groups) THEN ! DO j=1, dffts%nr1x*dffts%nr2x*dffts%tg_npp( me_bgrp + 1 ) tg_revc0(j,ibnd,1) = tg_psic(j) ENDDO ! ELSE ! revc0(1:dffts%nnr,ibnd,1) = psic(1:dffts%nnr) ! ENDIF ! ENDDO ! ELSE ! DO ik=1,nks ! DO ibnd=1,nbnd ! DO ig=1,npw_k(ik) ! revc0(nls(igk_k(ig,ik)),ibnd,ik)=& &evc0(ig,ibnd,ik) ! ENDDO ! dffts%have_task_groups=.false. CALL invfft ('Wave', revc0(:,ibnd,ik), dffts) dffts%have_task_groups=use_tg ! ENDDO ! ENDDO ! ENDIF ! OBM - Last minute check for real space implementation, IF ( real_space_debug > 0 .AND. .NOT. gamma_only ) & CALL errore( ' iosys ', ' Linear response calculation ' // & & 'real space algorithms with k-points not implemented', 1 ) ! END SUBROUTINE normal_read !----------------------------------------------------------------------- SUBROUTINE virt_read() ! The modifications to read also the virtual orbitals USE control_ph, ONLY : nbnd_occ USE becmod, ONLY : allocate_bec_type, deallocate_bec_type USE lr_variables, ONLY : davidson USE io_global, ONLY : stdout ! ! IMPLICIT NONE ! COMPLEX(kind=dp), ALLOCATABLE :: evc_all(:,:,:) COMPLEX(kind=dp), ALLOCATABLE :: sevc_all(:,:,:) REAL(kind=dp), ALLOCATABLE :: becp1_all(:,:) COMPLEX(kind=dp), ALLOCATABLE :: becp1_c_all(:,:,:) COMPLEX(kind=dp), ALLOCATABLE :: revc_all(:,:,:) ! ! Check for task groups WRITE( stdout, '(/5x,"Virt read")' ) IF (dffts%have_task_groups) CALL errore ( 'virt_read', 'Task & &groups not supported when there are virtual states in the & &input.', 1 ) ! ! First pretend everything is normal nbnd=nbnd_total ! ALLOCATE(revc_all(dffts%nnr,nbnd,nks)) ALLOCATE(evc_all(npwx,nbnd,nks)) ALLOCATE(sevc_all(npwx,nbnd,nks)) ALLOCATE(evc0_virt(npwx,(nbnd-nbnd_occ(1)),nks)) allocate(sevc0_virt(npwx,(nbnd-nbnd_occ(1)),nks)) ! ! XC: It's kind of messy to deallocate and alloacte again becp; This is mainly due to the ! change of nbnd. Later this operation need to be done again when we change nbnd back to nbnd_occ ! Again, I suggest please, in the future try the best not to change the meaning of global variables CALL deallocate_bec_type(becp) CALL allocate_bec_type ( nkb, nbnd, becp ) IF (nkb > 0) THEN IF(gamma_only) THEN ALLOCATE(becp1_all(nkb,nbnd)) becp1_all(:,:)=0.0d0 ELSE ALLOCATE(becp1_c_all(nkb,nbnd,nks)) becp1_c_all(:,:,:)=(0.0d0,0.0d0) ENDIF ENDIF nwordwfc = nbnd * npwx size_evc=npwx*nbnd_occ(1)*nks ! Read in the ground state wavefunctions ! This is a parallel read, done in wfc_dir tmp_dir_saved = tmp_dir !IF ( wfc_dir /= 'undefined' ) tmp_dir = wfc_dir wfc_dir = tmp_dir CALL diropn ( iunwfc, 'wfc', 2*nwordwfc, exst) IF (.NOT.exst .AND. wfc_dir == 'undefined') CALL errore(& &'lr_read_wfc', TRIM( prefix )//'.wfc'//' not found',1) IF (.NOT.exst .AND. wfc_dir /= 'undefined') THEN WRITE( stdout, '(/5x,"Attempting to read from outdir & &instead of wfcdir")' ) CLOSE( UNIT = iunwfc) tmp_dir = tmp_dir_saved CALL diropn ( iunwfc, 'wfc', 2*nwordwfc, exst) IF (.NOT.exst) CALL errore('lr_read_wfc', & &TRIM( prefix )//'.wfc'//' not found',1) ENDIF IF (gamma_only) THEN WRITE( stdout, '(/5x,"Gamma point algorithm")' ) ELSE WRITE( stdout, '(/5x,"Generalised algorithm !warning")' ) ENDIF DO ik=1,nks IF (.NOT. real_space_debug > 0 ) THEN !else done in init_realspace realus CALL gk_sort( xk(1,ik), ngm, g, ( ecutwfc / tpiba2 ), npw,& & igk, g2kin ) npw_k(ik) = npw igk_k(:,ik) = igk(:) ENDIF ! Read in the ground state wavefunctions ! This is a parallel read, done in wfc_dir CALL davcio(evc_all(:,:,ik),2*nwordwfc,iunwfc,ik,-1) ! ENDDO CLOSE( UNIT = iunwfc) ! End of file reading tmp_dir = tmp_dir_saved ! vkb * evc_all and initialization of sevc_all IF ( okvan ) THEN IF ( gamma_only ) THEN ! Following line is to be removed when real space ! implementation is complete CALL init_us_2(npw,igk_k(:,1),xk(1,1),vkb) IF (real_space_debug>0) THEN DO ibnd=1,nbnd,2 CALL fft_orbital_gamma(evc_all(:,:,1),ibnd,nbnd) CALL calbec_rs_gamma(ibnd,nbnd,becp1_all) becp%r(:,ibnd)=becp1_all(:,ibnd) IF (ibnd + 1 <= nbnd) becp%r(:,ibnd+1)=becp1_all(:,ibnd+1) CALL s_psir_gamma(ibnd,nbnd) CALL bfft_orbital_gamma(sevc_all(:,:,1),ibnd,nbnd) ENDDO ELSE CALL calbec(npw_k(1),vkb,evc_all(:,:,1),becp1_all) becp%r=becp1_all CALL s_psi(npwx, npw_k(1), nbnd, evc_all(:,:,1), & & sevc_all(:,:,1)) ENDIF ELSE ! K point generalized stuff starts here DO ik=1,nks CALL init_us_2(npw_k(ik),igk_k(1,ik),xk(1,ik),vkb) CALL calbec(npw_k(ik),vkb,evc_all(:,:,ik),& & becp1_c_all(:,:,ik),nbnd) becp%k=becp1_c_all(:,:,ik) CALL s_psi (npwx, npw_k(ik), nbnd, evc_all(:,:,ik), & & sevc_all(:,:,ik)) ENDDO ENDIF ELSE sevc_all=evc_all ENDIF ! Inverse fourier transform of evc_all ! ! revc_all=(0.0d0,0.0d0) nbnd=nbnd_occ(1) ! Very important, otherwise there will be bugs CALL deallocate_bec_type(becp) CALL allocate_bec_type ( nkb, nbnd, becp ) ! IF ( gamma_only ) THEN DO ibnd=1,nbnd,2 IF (ibnd0) THEN IF (gamma_only) THEN becp1(:,:)=becp1_all(:,1:nbnd) becp%r=0.0d0 becp%r=becp1 ELSE becp1_c(:,:,:)=becp1_c_all(:,1:nbnd,:) becp%k=(0.0d0,0.0d0) becp%k=becp1_c(:,:,1) ENDIF ENDIF ! ! Finally retain the conduction bands if needed for projection evc0_virt(:,:,:)=evc_all(:,nbnd+1:nbnd_total,:) sevc0_virt(:,:,:)=sevc_all(:,nbnd+1:nbnd_total,:) IF (nkb>0) THEN IF (gamma_only) THEN becp1_virt(:,:)=becp1_all(:,nbnd+1:nbnd_total) ELSE becp1_c_virt(:,:,:)=becp1_c_all(:,nbnd+1:nbnd_total,:) ENDIF ENDIF IF (nkb>0) THEN IF (gamma_only) THEN DEALLOCATE(becp1_all) ELSE DEALLOCATE(becp1_c_all) ENDIF ENDIF DEALLOCATE(evc_all) DEALLOCATE(sevc_all) DEALLOCATE(revc_all) ! OBM - Last minute check for real space implementation, IF ( real_space_debug > 0 .and. .not. gamma_only ) & CALL errore( ' iosys ', ' Linear response calculation ' // & & 'real space algorithms with k-points not implemented', 1 ) ! END SUBROUTINE virt_read !----------------------------------------------------------------------- END SUBROUTINE lr_read_wf TDDFPT/src/lr_variables.f900000755000175000017500000003225012341371472013710 0ustar mbamba! ! Copyright (C) 2001-2003 PWSCF group ! This file is distributed under the terms of the ! GNU General Public License. See the file `License' ! in the root directory of the present distribution, ! or http://www.gnu.org/copyleft/gpl.txt . ! MODULE lr_variables !-------------------------------------------------------------------------- ! ... sets the dimensions of the variables required in the ! ... Lanczos/linear response calculation !-------------------------------------------------------------------------- ! ! Modified by Osman Baris Malcioglu (2009) USE kinds, ONLY : dp USE control_flags, ONLY : gamma_only ! IMPLICIT NONE !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! ! Parameters !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! INTEGER, PARAMETER:: nbrx=14 ! max number of beta functions ! INTEGER :: iund0psi = 20 INTEGER :: iunrestart = 20 INTEGER :: nwordd0psi INTEGER :: nwordrestart ! CHARACTER (len=10), PARAMETER :: code = 'turboTDDFT' ! INTEGER :: n_ipol ! ! INTEGER :: size_evc ! CHARACTER (len=24) :: bgz_suffix ! !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! !Variables for TDHF using Dario Rocca's BSE routines. !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! LOGICAL :: lr_exx REAL(kind=dp), ALLOCATABLE :: xkk_m(:,:), xkk_p(:,:), weight_kk(:) REAL(kind=dp) :: exxdiv REAL(kind=dp) :: ecutfock_ ! REAL(kind=dp), ALLOCATABLE :: revc_int(:,:) ! COMPLEX(kind=dp), ALLOCATABLE :: revc_int_c(:,:,:) INTEGER, ALLOCATABLE :: & igkk_kk_m(:,:),& npw_kk_m(:),& ind_kk_m(:,:),& igkk_kk_p(:,:),& npw_kk_p(:),& ind_kk_p(:,:) REAL(kind=dp) :: scissor CHARACTER(len=200) :: eig_dir !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! ! !LOGICAL :: nlcc_any ! .T. if any atom-type has nlcc ! !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! !Global Variables !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! !REAL (DP), ALLOCATABLE :: dmuxc(:,:,:) ! nrxx, nspin, nspin), ! !REAL (DP), ALLOCATABLE :: & ! grho(:,:,:), &! 3, nrxx, nspin), ! dvxc_rr(:,:,:), &! nrxx, nspin, nspin), & ! dvxc_sr(:,:,:), &! nrxx, nspin, nspin), ! dvxc_ss(:,:,:), &! nrxx, nspin, nspin), & ! dvxc_s(:,:,:) ! nrxx, nspin, nspin) ! ! real(kind=dp), ALLOCATABLE :: becp1(:,:) COMPLEX(kind=dp), ALLOCATABLE :: becp1_c(:,:,:) real(kind=dp), ALLOCATABLE :: becp1_virt(:,:) COMPLEX(kind=dp), ALLOCATABLE :: becp1_c_virt(:,:,:) ! COMPLEX(kind=dp), ALLOCATABLE :: & evc0(:,:,:), & ! the ground state wavefunctions (plane wave, band, k point) evc0_virt(:,:,:), & ! unoccupied ground state wavefunctions (plane wave, band, k point) sevc0(:,:,:), & ! S * ground state wavefunctions sevc0_virt(:,:,:), & ! S * virtual ground state wavefunctions evc1_old(:,:,:,:), & ! response wavefunctions in the pw basis (last ! index 1: q' using rotated SBR 2: p') evc1(:,:,:,:), & ! " " evc1_new(:,:,:,:), & ! " " sevc1(:,:,:,:), sevc1_new(:,:,:,:),& ! S * " " d0psi(:,:,:,:) ! for saving the original starting vectors ! COMPLEX(kind=dp), ALLOCATABLE :: revc0(:,:,:) !ground state wavefunctions in real space COMPLEX(kind=dp), ALLOCATABLE :: tg_revc0(:,:,:) !ground state wavefunctions in real space ! real(kind=dp), ALLOCATABLE :: & rho_1(:,:) ! response charge density in real space !rho_tot(:), & ! ground state + resp. charge density in real space (obm: is it used at all?) COMPLEX(kind=dp), ALLOCATABLE :: & rho_1c(:,:) ! response charge density in real space ! !integer, allocatable :: & ! igk_k(:,:),& ! npw_k(:) ! INTEGER :: & nbnd_total !Actual number of bands calculated by PWSCF (virtual+ocuppied) ! INTEGER, ALLOCATABLE :: cube_save(:,:) !used in response charge density mode 1 ! COMPLEX(kind=dp), ALLOCATABLE :: F(:,:,:) !the intensity of transition from valance state (first index) ! to conduction state (second index), for each polarization !direction (third index) COMPLEX(kind=dp), ALLOCATABLE :: R(:,:,:) !the oscillator strength from valanace state (first index) ! to conduction state (second index), for each polarization !direction (third index) ! !open shell related... ! !real(kind=dp) :: lr_alpha_pv ! Spread in eigenvalues !integer, allocatable :: nbnd_occ(:) !number of occupied points for the given k point !integer, allocatable :: & ! igk_k(:,:),& ! The g<->k correspondance for each k point ! npw_k(:) ! number of plane waves at each k point ! They are (used many times, it is much better to hold them in memory ! !Lanczos Matrix ! ! ! | alpha(:,1), gamma(:,2), 0| ! | beta(:,2) , alpha(:,2), gamma(:,3) | ! T^j = | , beta(:,3) , ... | ! | | ! | ..., gamma(:,j) | ! |0 beta(:,j) , alpha(:,j) | ! ! Zeta is the \sum_valance (V^T_j * r_i ) where r_i is the density operator acting ! on ground state orbitals ! ! zeta.w_T gives the polarizability (w_T is the solution of ! (\omega-L)e_1 = w_T , this is handled in a post processing program) ! real(kind=dp), ALLOCATABLE :: & ! (pol, iter) alpha_store(:,:),& beta_store(:,:),& gamma_store(:,:) COMPLEX(kind=dp), ALLOCATABLE :: zeta_store(:,:,:) !polarization of external field, polarization of internal field, iteration number. ! !The currently processed polarization direction and Lanczos iteration ! INTEGER :: LR_iteration, LR_polarization !polarization directions 1:x 2:y 3:z ! ! variables for diagonalising the coefficient matrix ! real(kind=dp) :: lanc_norm real(kind=dp), ALLOCATABLE :: eval1(:),eval2(:) real(kind=dp), ALLOCATABLE :: vl(:,:),vr(:,:) ! REAL(kind=dp) :: norm0(3) LOGICAL :: davidson = .false. ! !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! ! lr_input: !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! ! ! LOGICAL :: restart ! set True if the calculation is a restart run INTEGER :: restart_step ! the amount of steps to write a restart file ! INTEGER :: lr_verbosity ! verbosity level for linear response routines ! INTEGER :: test_case_no = 0 ! OBM, this dummy variable performs various tests INTEGER :: lr_io_level = 1 ! Controls disk io ! !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! ! lr_control: !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! ! INTEGER :: charge_response ! A variable for calculating response charge density ! INTEGER :: itermax ! number of Lanczos vectors to be calculated INTEGER :: itermax_int ! interpolated number of lanczos steps for Ritz vectors LOGICAL :: ltammd ! Tarn-Darnkhoff approximation LOGICAL :: d0psi_rs ! Calculate d0psi in the real space LOGICAL :: pseudo_hermitian ! If psedudo hermitian algorithm is used LOGICAL :: no_hxc ! If .true. no hartree exchange correlation corrections will be considered. LOGICAL :: project ! If .true. projections to read virtual states will be calculated ! ! !integer :: ipol ! sets the polarization direction to be calculated. (Used as a variable if 4) ! ! 1=x 2=y 3=z 4=x,y,z ! !integer :: grid_coarsening ! Coarses the real space grid (by dividing nr1x nr2x and nr3x by this value) ! ! ! !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! ! lr_post: !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! ! !real(kind=dp) :: broadening !Broadening INTEGER :: plot_type ! Dumps rho as: 1=xyzd 2=xsf 3=cube !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! !! Debugging subroutines !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! CONTAINS !---------------------------------------------------------------------------- SUBROUTINE check_vector_gamma (x) ! Checks the inner product for a given vector, and its imaginary and real ! component ! input, evc ! output : screen output USE mp_global, ONLY : inter_pool_comm, intra_bgrp_comm USE mp, ONLY : mp_sum USE realus, ONLY : npw_k USE gvect, ONLY : gstart USE io_global, ONLY : stdout IMPLICIT NONE !input/output COMPLEX(kind=dp),INTENT(in) :: x(:) !local real(kind=dp) :: temp_gamma real(kind=dp), EXTERNAL :: DDOT temp_gamma = 2.D0*DDOT(2*npw_k(1),x(:),1,x(:),1) IF (gstart==2) temp_gamma = temp_gamma - dble(x(1))*dble(x(1)) #ifdef __MPI CALL mp_sum(temp_gamma, intra_bgrp_comm) #endif WRITE(stdout,'(" = ",E15.8)') temp_gamma END SUBROUTINE check_vector_gamma !---------------------------------------------------------------------------- SUBROUTINE check_vector_f (x) ! Checks the inner product for a given vector, and its imaginary and real ! component ! input, evc ! output : screen output USE mp_global, ONLY : inter_pool_comm, intra_bgrp_comm USE mp, ONLY : mp_sum USE realus, ONLY : npw_k USE gvect, ONLY : gstart USE io_global, ONLY : stdout IMPLICIT NONE !input/output COMPLEX(kind=dp),INTENT(in) :: x(:) !local COMPLEX(kind=dp) :: temp_f COMPLEX(kind=dp), EXTERNAL :: zdotc temp_f = zdotc(npw_k(1),x(:),1,x(:),1) #ifdef __MPI CALL mp_sum(temp_f, intra_bgrp_comm) #endif WRITE(stdout,'(" = ",2E15.8,1X)') temp_f END SUBROUTINE check_vector_f !---------------------------------------------------------------------------- SUBROUTINE check_all_bands_gamma (x,sx,nbnd1,nbnd2) ! Checks all bands of given KS states for orthoganilty ! input, evc and sevc ! output : screen output USE mp_global, ONLY : inter_pool_comm, intra_bgrp_comm USE mp, ONLY : mp_sum USE realus, ONLY : npw_k USE io_global, ONLY : stdout USE gvect, ONLY : gstart IMPLICIT NONE !input/output INTEGER,INTENT(in) :: nbnd1,nbnd2 !Total number of bands for x and sx COMPLEX(kind=dp),INTENT(in) :: x(:,:), sx(:,:) !local INTEGER :: ibnd, jbnd real(kind=dp) :: temp_gamma real(kind=dp), EXTERNAL :: DDOT DO ibnd=1,nbnd1 DO jbnd=ibnd,nbnd2 ! temp_gamma = 2.D0*DDOT(2*npw_k(1),x(:,ibnd),1,sx(:,jbnd),1) IF (gstart==2) temp_gamma = temp_gamma - dble(x(1,ibnd))*dble(sx(1,jbnd)) #ifdef __MPI CALL mp_sum(temp_gamma, intra_bgrp_comm) #endif WRITE(stdout,'(" =",E15.8)') ibnd,jbnd,temp_gamma ENDDO ENDDO END SUBROUTINE check_all_bands_gamma !---------------------------------------------------------------------------- SUBROUTINE check_density_gamma (rx,nbnd) ! Checks the contirbution of a given function transformed into real space ! input, revc ! output : screen output USE mp_global, ONLY : inter_pool_comm, intra_bgrp_comm USE mp, ONLY : mp_sum USE realus, ONLY : npw_k USE wvfct, ONLY : wg USE fft_base, ONLY : dfftp USE io_global, ONLY : stdout USE cell_base, ONLY : omega IMPLICIT NONE !input/output INTEGER,INTENT(in) :: nbnd !Total number of bands for x and sx COMPLEX(kind=dp),INTENT(in) :: rx(:,:) !local INTEGER :: ibnd real(kind=dp) :: temp_gamma,w1,w2 DO ibnd=1,nbnd,2 w1=wg(ibnd,1)/omega ! IF(ibnd nbnd_occ(1)) THEN WRITE(stdout,'(/,5X,"Virtual states in ground state run will be used in& & projection analysis")') ELSE ! WRITE(stdout,'(/,5X,"No virtual states for projection found")') project=.FALSE. ! RETURN ! ENDIF ! CALL sd0psi() ! CALL lr_calc_R() ! DO ip=1, n_ipol ! WRITE(stdout,'(/,/5x,"Oscillator strengths for polarization & &direction",1x,i8)') ip WRITE(stdout,'(5x,"occ",1x,"con",8x,"Re(R)",14x,"Im(R)")') ! DO ibnd_occ = 1, nbnd ! DO ibnd_virt = 1, (nbnd_total-nbnd) ! WRITE(stdout,'(5x,i3,1x,i3,3x,E16.8,2X,E16.8)') & ibnd_occ, ibnd_virt, DBLE( R(ibnd_occ, ibnd_virt, ip) ),& &AIMAG( R(ibnd_occ, ibnd_virt, ip) ) ENDDO ! ENDDO ! ENDDO ! RETURN ! END SUBROUTINE lr_project_init !--------------------------------------------------------------------- SUBROUTINE read_wT_beta_gamma_z() !----------------------------------------------------------------------- ! Reads beta_gamma_z from a previous calculation for the given polarization ! direction pol. !--------------------------------------------------------------------- ! USE mp, ONLY : mp_bcast, mp_barrier USE lr_variables, ONLY : LR_polarization, itermax USE mp_global, ONLY : inter_pool_comm, intra_bgrp_comm USE mp_world, ONLY : world_comm ! IMPLICIT NONE ! CHARACTER(LEN=256), EXTERNAL :: trimcheck ! CHARACTER(len=6), EXTERNAL :: int_to_char ! local LOGICAL :: exst INTEGER :: iter_restart,i,j CHARACTER(len=256) :: filename CALL start_clock( 'post-processing' ) IF (lr_verbosity > 5) WRITE(stdout,'("")') #ifdef __MPI IF (ionode) THEN #endif ! ! !if (.not. allocated(w_T_beta_store)) print *, "aaaaaaaaaaaaaa" filename = trim(w_T_prefix) // trim(int_to_char(LR_polarization)) ! WRITE(stdout,'(/,/5x,"Reading Pre-calculated lanczos coefficents from ",A50)') filename ! INQUIRE (file = filename, exist = exst) ! IF (.not.exst) CALL errore(' read_beta_gamma_z ','Stage 1 Lanczos coefficents not found ',1) ! ! OPEN (158, file = filename, form = 'formatted', status = 'old') INQUIRE (file = filename, opened = exst) IF (.not.exst) CALL errore(' read_beta_gamma_z ','Stage 1 Lanczos coefficents can not be opened ',1) ! ! READ(158,*,end=301,err=302) iter_restart !print *,iter_restart !write(stdout,'(/,5X,"Reading of precalculated Lanczos Matrix")') IF (iter_restart < itermax) CALL errore ('read_beta_gamma_z', 'Lanczos iteration mismatch', 1 ) ! IF (.not. allocated(w_T_beta_store)) ALLOCATE(w_T_beta_store(iter_restart)) IF (.not. allocated(w_T_gamma_store)) ALLOCATE(w_T_gamma_store(iter_restart)) READ(158,*,end=301,err=303) w_T_norm0_store !print *, discard ! !write(stdout,'("--------------Lanczos Matrix-------------------")') DO i=1,itermax ! !print *, "Iter=",i READ(158,*,end=301,err=303) w_T_beta_store(i) !print *, w_T_beta_store(i) READ(158,*,end=301,err=303) w_T_gamma_store(i) !print *, w_T_gamma_store(i) DO j=1,w_T_npol READ(158,*,end=301,err=303) w_T_zeta_store(j,i) ENDDO !print *, discard2(:) ! ENDDO !print *, "closing file" ! CLOSE(158) ! !print *, "starting broadcast" #ifdef __MPI ENDIF CALL mp_barrier(world_comm) CALL mp_bcast (w_T_beta_store(:), ionode_id, world_comm) CALL mp_bcast (w_T_gamma_store(:), ionode_id, world_comm) CALL mp_bcast (w_T_zeta_store(:,:), ionode_id, world_comm) CALL mp_bcast (w_T_norm0_store, ionode_id, world_comm) #endif !print *, "broadcast complete" WRITE(stdout,'(5x,I8,1x,"steps succesfully read for polarization index",1x,I3)') itermax,LR_polarization CALL stop_clock( 'post-processing' ) RETURN 301 CALL errore ('read_beta_gamma_z', 'File is corrupted, no data', i ) 302 CALL errore ('read_beta_gamma_z', 'File is corrupted, itermax not found', 1 ) 303 CALL errore ('read_beta_gamma_z', 'File is corrupted, data number follows:', i ) END SUBROUTINE read_wT_beta_gamma_z !----------------------------------------------------------------------- SUBROUTINE lr_calc_w_T() !--------------------------------------------------------------------- ! ... calculates the w_T from equation (\freq - L ) e_1 ! ... by solving tridiagonal problem for each value of freq !--------------------------------------------------------------------- ! USE lr_variables, ONLY : itermax,beta_store,gamma_store, & LR_polarization,charge_response, n_ipol, & itermax_int,project USE fft_base, ONLY : dfftp USE noncollin_module, ONLY : nspin_mag ! IMPLICIT NONE ! !integer, intent(in) :: freq ! Input : The frequency identifier (1 o 5) for w_T COMPLEX(kind=dp), ALLOCATABLE :: a(:), b(:), c(:),r(:) real(kind=dp) :: average,av_amplitude COMPLEX(kind=dp) :: norm ! INTEGER :: i, info,ip,ip2 !used for error reporting INTEGER :: counter LOGICAL :: skip !Solver: real(kind=dp), EXTERNAL :: ddot COMPLEX(kind=dp), EXTERNAL :: zdotc ! CALL start_clock( 'post-processing' ) IF (lr_verbosity > 5) THEN WRITE(stdout,'("")') ENDIF IF (omeg == 0.D0) THEN CALL stop_clock( 'post-processing' ) RETURN END IF ! ALLOCATE(a(itermax_int)) ALLOCATE(b(itermax_int)) ALLOCATE(c(itermax_int)) ALLOCATE(r(itermax_int)) ! a(:) = (0.0d0,0.0d0) b(:) = (0.0d0,0.0d0) c(:) = (0.0d0,0.0d0) w_T(:) = (0.0d0,0.0d0) ! WRITE(stdout,'(/,5X,"Calculating response coefficients")') ! ! ! ! prepare tridiagonal (w-L) for the given polarization ! a(:) = cmplx(omeg,epsil,dp) ! IF (charge_response == 2) THEN DO i=1,itermax-1 ! !Memory mapping in case of selected polarization direction info=1 IF ( n_ipol /= 1 ) info=LR_polarization ! b(i)=-beta_store(info,i) c(i)=-gamma_store(info,i) ! ENDDO ENDIF IF (charge_response == 1) THEN !Read the actual iterations DO i=1,itermax ! !b(i)=-w_T_beta_store(i) !c(i)=-w_T_gamma_store(i) b(i)=cmplx(-w_T_beta_store(i),0.0d0,dp) c(i)=cmplx(-w_T_gamma_store(i),0.0d0,dp) ! ENDDO IF (itermax_int>itermax .and. itermax > 151) THEN !calculation of the average !OBM: (I am using the code from tddfpt_pp, I am not very confortable ! with the mechanism discarding the "bad" points. average=0.d0 av_amplitude=0.d0 counter=0 skip=.false. ! DO i=151,itermax ! IF (skip .eqv. .true.) THEN skip=.false. CYCLE ENDIF ! IF (mod(i,2)==1) THEN ! IF ( i/=151 .and. abs( w_T_beta_store(i)-average/counter ) > 2.d0 ) THEN ! !if ( i.ne.151 .and. counter == 0) counter = 1 skip=.true. ! ELSE ! average=average+w_T_beta_store(i) av_amplitude=av_amplitude+w_T_beta_store(i) counter=counter+1 !print *, "t1 ipol",ip,"av_amp",av_amplitude(ip) ! ENDIF ! ELSE ! IF ( i/=151 .and. abs( w_T_beta_store(i)-average/counter ) > 2.d0 ) THEN ! !if ( i.ne.151 .and. counter == 0) counter = 1 skip=.true. ! ELSE ! average=average+w_T_beta_store(i) av_amplitude=av_amplitude-w_T_beta_store(i) counter=counter+1 !print *, "t2 ipol",ip,"av_amp",av_amplitude(ip) ! ENDIF ! ENDIF ! ! ENDDO average=average/counter av_amplitude=av_amplitude/counter ! ! WRITE(stdout,'(/,5X,"Charge Response extrapolation average: ",E15.5)') average WRITE(stdout,'(5X,"Charge Response extrapolation oscillation amplitude: ",E15.5)') av_amplitude !extrapolated part of b and c DO i=itermax,itermax_int ! IF (mod(i,2)==1) THEN ! b(i)=cmplx((-average-av_amplitude),0.0d0,dp) c(i)=b(i) ! ELSE ! b(i)=cmplx((-average+av_amplitude),0.0d0,dp) c(i)=b(i) ! ENDIF ! ENDDO ENDIF ENDIF ! r(:) =(0.0d0,0.0d0) r(1)=(1.0d0,0.0d0) ! ! solve the equation ! CALL zgtsv(itermax_int,1,b,a,c,r(:),itermax_int,info) IF(info /= 0) CALL errore ('calc_w_T', 'unable to solve tridiagonal system', 1 ) w_t(:)=r(:) ! !Check if we are close to a resonance ! norm=sum(abs(aimag(w_T(:))/dble(w_T(:)))) norm=norm/(1.0d0*itermax_int) !print *,"norm",norm IF (abs(norm) > 0.1) THEN resonance_condition=.true. IF (allocated(rho_1_tot)) DEALLOCATE (rho_1_tot) IF (.not. allocated(rho_1_tot_im)) ALLOCATE(rho_1_tot_im(dfftp%nnr,nspin_mag)) rho_1_tot_im(:,:)=cmplx(0.0d0,0.0d0,dp) ELSE resonance_condition=.false. IF (allocated(rho_1_tot_im)) DEALLOCATE (rho_1_tot_im) IF (.not. allocated(rho_1_tot)) ALLOCATE(rho_1_tot(dfftp%nnr,nspin_mag)) rho_1_tot(:,:)=0.0d0 ENDIF IF (resonance_condition) THEN WRITE(stdout,'(5X,"Resonance frequency mode enabled")') !write(stdout,'(5X,"Response charge density multiplication factor=",E15.8)') 1.0d0/epsil**2 ENDIF ! ! normalize so that the final charge densities are normalized ! norm=zdotc(itermax_int,w_T(:),1,w_T(:),1) WRITE(stdout,'(5X,"Charge Response renormalization factor: ",2(E15.5,1x))') norm !w_T(:)=w_T(:)/norm !norm=sum(w_T(:)) !write(stdout,'(3X,"Initial sum of lanczos vectors",F8.5)') norm !w_T(:)=w_T(:)/norm ! ! !Calculate polarizability tensor in the case of projection IF (project) THEN DO ip=1,w_T_npol ! chi(LR_polarization,ip)=zdotc(itermax,w_T_zeta_store(ip,:),1,w_T(:),1) chi(LR_polarization,ip)=chi(LR_polarization,ip)*cmplx(w_T_norm0_store,0.0d0,dp) ! WRITE(stdout,'(5X,"Chi_",I1,"_",I1,"=",2(E15.5,1x))') LR_polarization,ip,chi(LR_polarization,ip) ENDDO ENDIF ! ! DEALLOCATE(a) DEALLOCATE(b) DEALLOCATE(c) DEALLOCATE(r) ! IF ( lr_verbosity > 3 ) THEN WRITE(stdout,'("--------Lanczos weight coefficients in the direction ", & & I1," for freq=",D15.8," Ry ----------")') LR_polarization, omeg DO i=1,itermax WRITE(stdout,'(I5,3X,2D15.8)') i, w_T(i) ENDDO WRITE(stdout,'("------------------------------------------------------------------------")') WRITE(stdout,'("NR1=",I15," NR2=",I15," NR3=",I15)') dfftp%nr1, dfftp%nr2, dfftp%nr3 WRITE(stdout,'("------------------------------------------------------------------------")') ENDIF CALL stop_clock( 'post-processing' ) RETURN ! END SUBROUTINE lr_calc_w_T !----------------------------------------------------------------------- SUBROUTINE lr_calc_F(evc1) !------------------------------------------------------------------------------- ! Calculates the projection of empty states to response orbitals ! USE lsda_mod, ONLY : nspin USE mp, ONLY : mp_sum USE mp_global, ONLY : inter_pool_comm, intra_bgrp_comm USE uspp, ONLY : okvan,qq,vkb USE wvfct, ONLY : wg,nbnd,npwx USE uspp_param, ONLY : upf, nh USE becmod, ONLY : becp,calbec USE ions_base, ONLY : ityp,nat,ntyp=>nsp USE realus, ONLY : npw_k,real_space_debug,fft_orbital_gamma,calbec_rs_gamma USE gvect, ONLY : gstart USE klist, ONLY : nks USE lr_variables, ONLY : lr_verbosity, itermax, LR_iteration, LR_polarization, & project,evc0_virt,F,nbnd_total,n_ipol, becp1_virt IMPLICIT NONE ! !input COMPLEX(kind=dp), INTENT(in) :: evc1(npwx,nbnd,nks) ! !internal variables INTEGER :: ibnd_occ,ibnd_virt,ipol real(kind=dp) :: w1,w2,scal INTEGER :: ir,ik,ibnd,jbnd,ig,ijkb0,np,na,ijh,ih,jh,ikb,jkb,ispin !complex(kind=dp) :: SSUM real(kind=dp) :: SSUM ! !functions real(kind=dp), EXTERNAL :: DDOT !complex(kind=dp), external :: ZDOTC ! scal=0.0d0 ! ! I calculate the projection from ! F=2(+\sum Q IF ( .not. project) RETURN IF (n_ipol>1) THEN ipol=LR_polarization ELSE ipol=1 ENDIF IF (okvan) THEN !BECP initialisation for evc1 IF (real_space_debug >6) THEN DO ibnd=1,nbnd,2 CALL fft_orbital_gamma(evc1(:,:,1),ibnd,nbnd) CALL calbec_rs_gamma(ibnd,nbnd,becp%r) ENDDO ELSE CALL calbec(npw_k(1), vkb, evc1(:,:,1), becp) ENDIF ENDIF ! !!! Actual projection starts here ! DO ibnd_occ=1,nbnd DO ibnd_virt=1,(nbnd_total-nbnd) ! !ultrasoft part ! IF (okvan) THEN !initalization scal = 0.0d0 ! !Calculation of qq ! w1 = wg(ibnd,1) ijkb0 = 0 ! DO np = 1, ntyp ! IF ( upf(np)%tvanp ) THEN ! DO na = 1, nat ! IF ( ityp(na) == np ) THEN ! ijh = 1 ! DO ih = 1, nh(np) ! ikb = ijkb0 + ih ! ! terms ! scal = scal + qq(ih,ih,np) *1.d0 * becp%r(ikb,ibnd_occ) * becp1_virt(ikb,ibnd_virt) ! ijh = ijh + 1 ! ! terms ! DO jh = ( ih + 1 ), nh(np) ! jkb = ijkb0 + jh ! scal = scal + qq(ih,jh,np) *1.d0 * (becp%r(ikb,ibnd_occ) * becp1_virt(jkb,ibnd_virt)+& becp%r(jkb,ibnd_occ) * becp1_virt(ikb,ibnd_virt)) ! ijh = ijh + 1 ! ENDDO ! ENDDO ! ijkb0 = ijkb0 + nh(np) ! ENDIF ! ENDDO ! ELSE ! DO na = 1, nat ! IF ( ityp(na) == np ) ijkb0 = ijkb0 + nh(np) ! ENDDO ! ENDIF ! ENDDO ! ENDIF ! US part finished !first part ! the dot product taken from lr_dot SSUM=(2.D0*wg(ibnd_occ,1)*DDOT(2*npw_k(1),evc0_virt(:,ibnd_virt,1),1,evc1(:,ibnd_occ,1),1)) IF (gstart==2) SSUM = SSUM - (wg(ibnd_occ,1)*dble(evc1(1,ibnd_occ,1))*dble(evc0_virt(1,ibnd_virt,1))) !US contribution SSUM=SSUM+scal #ifdef __MPI CALL mp_sum(SSUM, intra_bgrp_comm) #endif IF(nspin/=2) SSUM=SSUM/2.0D0 ! ! !and finally (note:parellization handled in dot product, each node has the copy of F) ! F(ibnd_occ,ibnd_virt,ipol)=F(ibnd_occ,ibnd_virt,ipol)+cmplx(SSUM,0.0d0,dp)*w_T(LR_iteration) ENDDO ENDDO END SUBROUTINE lr_calc_F !------------------------------------------------------------------------------- SUBROUTINE lr_calc_R() !------------------------------------------------------------------------------- ! Calculates the oscillator strengths ! USE lsda_mod, ONLY : nspin USE mp, ONLY : mp_sum USE mp_global, ONLY : inter_pool_comm, intra_bgrp_comm USE uspp, ONLY : okvan,qq,vkb USE wvfct, ONLY : wg,nbnd,npwx USE uspp_param, ONLY : upf, nh USE becmod, ONLY : becp,calbec USE ions_base, ONLY : ityp,nat,ntyp=>nsp USE realus, ONLY : npw_k,real_space_debug,fft_orbital_gamma,calbec_rs_gamma USE gvect, ONLY : gstart USE klist, ONLY : nks USE lr_variables, ONLY : lr_verbosity, itermax, LR_iteration, LR_polarization, & project,evc0_virt,R,nbnd_total,n_ipol, becp1_virt,d0psi IMPLICIT NONE ! ! !internal variables INTEGER :: ibnd_occ,ibnd_virt,ipol real(kind=dp) :: SSUM ! !functions real(kind=dp), EXTERNAL :: DDOT ! DO ipol=1,n_ipol DO ibnd_occ=1,nbnd DO ibnd_virt=1,(nbnd_total-nbnd) ! the dot product taken from lr_dot SSUM=(2.D0*wg(ibnd_occ,1)*DDOT(2*npw_k(1),evc0_virt(:,ibnd_virt,1),1,d0psi(:,ibnd_occ,1,ipol),1)) IF (gstart==2) SSUM = SSUM - (wg(ibnd_occ,1)*dble(d0psi(1,ibnd_occ,1,ipol))*dble(evc0_virt(1,ibnd_virt,1))) #ifdef __MPI CALL mp_sum(SSUM, intra_bgrp_comm) #endif IF(nspin/=2) SSUM=SSUM/2.0D0 ! R(ibnd_occ,ibnd_virt,ipol)=cmplx(SSUM,0.0d0,dp) ENDDO ENDDO ENDDO END SUBROUTINE lr_calc_R !----------------------------------------------------------------------- SUBROUTINE lr_dump_rho(plot_type) !----------------------------------------------------------------------- ! ! This routine acts as an interface to all of the various lr_dump_* routines ! and calls the apropriate ones, based on the plot type specified in input ! and whether the resonance condition is satisfied. ! !----------------------------------------------------------------------- USE kinds, ONLY : DP ! IMPLICIT NONE ! INTEGER, INTENT(IN) :: plot_type ! IF (resonance_condition) THEN !response charge density, absorbtive IF (plot_type == 1 .or. plot_type == 5) & CALL lr_dump_rho_tot_xyzd(aimag(rho_1_tot_im(:,1)),"absorbtive") IF (plot_type == 2 .or. plot_type == 5) & CALL lr_dump_rho_tot_xcrys(aimag(rho_1_tot_im(:,1)),"absorbtive") IF (plot_type == 3 .or. plot_type == 5) & CALL lr_dump_rho_tot_cube(aimag(rho_1_tot_im(:,1)),"absorbtive") !response charge density, dispersive IF (plot_type == 1 .or. plot_type == 5) & CALL lr_dump_rho_tot_xyzd(dble(rho_1_tot_im(:,1)),"dispersive") IF (plot_type == 2 .or. plot_type == 5) & CALL lr_dump_rho_tot_xcrys(dble(rho_1_tot_im(:,1)),"dispersive") IF (plot_type == 3 .or. plot_type == 5) & CALL lr_dump_rho_tot_cube(dble(rho_1_tot_im(:,1)),"dispersive") ELSE IF (plot_type == 1 .OR. plot_type == 5) & & CALL lr_dump_rho_tot_xyzd(rho_1_tot(:,1),"summed-rho") IF (plot_type == 2 .OR. plot_type == 5) & & CALL lr_dump_rho_tot_xcrys(rho_1_tot(:,1),"summed-rho") IF (plot_type == 3 .OR. plot_type == 5) & & CALL lr_dump_rho_tot_cube(rho_1_tot(:,1),"summed-rho") ENDIF ! RETURN ! END SUBROUTINE lr_dump_rho !----------------------------------------------------------------------- SUBROUTINE lr_dump_rho_tot_compat1() !----------------------------------------------------------------------- ! dump a density file in a format compatible to type 1 charge response calculation !----------------------------------------------------------------------- USE io_files, ONLY : prefix USE lr_variables, ONLY : LR_polarization, LR_iteration, cube_save USE fft_base, ONLY : dfftp USE mp_global, ONLY : inter_pool_comm, intra_bgrp_comm IMPLICIT NONE CHARACTER(len=6), EXTERNAL :: int_to_char ! !Local CHARACTER (len=80):: filename real(kind=dp), ALLOCATABLE :: rho_sum_resp_x(:),rho_sum_resp_y(:),rho_sum_resp_z(:) INTEGER ir,i,j,k CALL start_clock( 'post-processing' ) IF (lr_verbosity > 5) WRITE(stdout,'("")') #ifdef __MPI IF (ionode) THEN #endif ! IF ( .not. allocated(cube_save) ) CALL lr_set_boxes_density() ALLOCATE( rho_sum_resp_x( dfftp%nr1 ) ) ALLOCATE( rho_sum_resp_y( dfftp%nr2 ) ) ALLOCATE( rho_sum_resp_z( dfftp%nr3 ) ) ! rho_sum_resp_x = 0.D0 rho_sum_resp_y = 0.D0 rho_sum_resp_z = 0.D0 ! DO ir=1,dfftp%nnr ! i=cube_save(ir,1)+1 j=cube_save(ir,2)+1 k=cube_save(ir,3)+1 ! rho_sum_resp_x(i)=rho_sum_resp_x(i)+rho_1_tot(ir,1) rho_sum_resp_y(j)=rho_sum_resp_y(j)+rho_1_tot(ir,1) rho_sum_resp_z(k)=rho_sum_resp_z(k)+rho_1_tot(ir,1) ! ENDDO ! ! filename = trim(prefix) // "-summed-density-pol" //trim(int_to_char(LR_polarization))// "_x" ! OPEN (158, file = filename, form = 'formatted', status = 'unknown', position = 'append') ! DO i=1,dfftp%nr1 WRITE(158,*) rho_sum_resp_x(i) ENDDO ! CLOSE(158) ! filename = trim(prefix) // "-summed-density-pol" //trim(int_to_char(LR_polarization))// "_y" ! OPEN (158, file = filename, form = 'formatted', status = 'unknown', position = 'append') ! DO i=1,dfftp%nr2 WRITE(158,*) rho_sum_resp_y(i) ENDDO ! CLOSE(158) ! filename = trim(prefix) // "-summed-density-pol" //trim(int_to_char(LR_polarization))// "_z" ! OPEN (158, file = filename, form = 'formatted', status = 'unknown', position = 'append') ! DO i=1,dfftp%nr3 WRITE(158,*) rho_sum_resp_z(i) ENDDO ! CLOSE(158) DEALLOCATE( rho_sum_resp_x ) DEALLOCATE( rho_sum_resp_y ) DEALLOCATE( rho_sum_resp_z ) ! #ifdef __MPI ENDIF #endif CALL stop_clock( 'post-processing' ) ! !----------------------------------------------------------------------- END SUBROUTINE lr_dump_rho_tot_compat1 !----------------------------------------------------------------------- SUBROUTINE lr_dump_rho_tot_cube(rho,identifier) !----------------------------------------------------------------------- ! dump a density file in the gaussian cube format. "Inspired" by ! Modules/cube.f90 :) !----------------------------------------------------------------------- USE io_files, ONLY : prefix USE lr_variables, ONLY : LR_polarization, LR_iteration, cube_save USE cell_base USE ions_base, ONLY : nat, ityp, atm, ntyp => nsp, tau USE mp, ONLY : mp_barrier, mp_sum, mp_bcast, mp_get USE mp_world, ONLY : world_comm USE mp_global, ONLY : me_image, intra_image_comm, me_bgrp, & nproc_bgrp, intra_bgrp_comm, my_bgrp_id USE constants, ONLY : BOHR_RADIUS_ANGS USE fft_base, ONLY : dfftp !this contains dfftp%npp (number of z planes per processor ! and dfftp%ipp (offset of the first z plane of the processor ! IMPLICIT NONE ! real (kind=dp), INTENT(in) :: rho(:) CHARACTER(len=10), INTENT(in) :: identifier ! CHARACTER(len=80) :: filename ! CHARACTER(len=6), EXTERNAL :: int_to_char ! !Local INTEGER :: i, nt, i1, i2, i3, at_num, iopool_id, ldr, kk, ionode_pool, six_count real(DP) :: at_chrg, tpos(3), inpos(3) REAL(DP), ALLOCATABLE :: rho_plane(:),rho_temp(:) INTEGER, ALLOCATABLE :: kowner(:) ! INTEGER, EXTERNAL:: atomic_number ! CALL start_clock( 'post-processing' ) IF (lr_verbosity > 5) WRITE(stdout,'("")') ! six_count=0 #ifdef __MPI ALLOCATE( rho_temp(dfftp%npp(1)+1) ) IF (ionode) THEN filename = trim(prefix) // "-" // identifier // "-pol" //trim(int_to_char(LR_polarization))// ".cube" WRITE(stdout,'(/5X,"Writing Cube file for response charge density")') !write(stdout, *) filename !write(stdout,'(5X,"|rho|=",D15.8)') rho_sum OPEN (158, file = filename, form = 'formatted', status = 'replace', err=501) !C WRITE A FORMATTED 'DENSITY-STYLE' CUBEFILE VERY SIMILAR !C TO THOSE CREATED BY THE GAUSSIAN PROGRAM OR THE CUBEGEN UTILITY. !C THE FORMAT IS AS FOLLOWS (LAST CHECKED AGAINST GAUSSIAN 98): !C !C LINE FORMAT CONTENTS !C =============================================================== !C 1 A TITLE !C 2 A DESCRIPTION OF PROPERTY STORED IN CUBEFILE !C 3 I5,3F12.6 #ATOMS, X-,Y-,Z-COORDINATES OF ORIGIN !C 4-6 I5,3F12.6 #GRIDPOINTS, INCREMENT VECTOR !C #ATOMS LINES OF ATOM COORDINATES: !C ... I5,4F12.6 ATOM NUMBER, CHARGE, X-,Y-,Z-COORDINATE !C REST: 6E13.5 CUBE DATA !C !C ALL COORDINATES ARE GIVEN IN ATOMIC UNITS. WRITE(158,*) 'Cubfile created from TDDFPT calculation' WRITE(158,*) identifier ! origin is forced to (0.0,0.0,0.0) WRITE(158,'(I5,3F12.6)') nat, 0.0d0, 0.0d0, 0.0d0 WRITE(158,'(I5,3F12.6)') dfftp%nr1, (alat*at(i,1)/dble(dfftp%nr1),i=1,3) WRITE(158,'(I5,3F12.6)') dfftp%nr2, (alat*at(i,2)/dble(dfftp%nr2),i=1,3) WRITE(158,'(I5,3F12.6)') dfftp%nr3, (alat*at(i,3)/dble(dfftp%nr3),i=1,3) DO i=1,nat nt = ityp(i) ! find atomic number for this atom. at_num = atomic_number(trim(atm(nt))) at_chrg= dble(at_num) ! at_chrg could be alternatively set to valence charge ! positions are in cartesian coordinates and a.u. ! ! wrap coordinates back into cell. tpos = matmul( transpose(bg), tau(:,i) ) tpos = tpos - nint(tpos - 0.5d0) inpos = alat * matmul( at, tpos ) WRITE(158,'(I5,5F12.6)') at_num, at_chrg, inpos ENDDO ENDIF ! Header is complete, now dump the charge density, as derived from xyzd subroutine ALLOCATE( rho_plane( dfftp%nr3x ) ) !ALLOCATE( kowner( dfftp%nr3 ) ) ! ! ... find the index of the pool that will write rho ! IF ( ionode ) iopool_id = my_bgrp_id ! CALL mp_bcast( iopool_id, ionode_id, intra_image_comm ) ! ! ... find the index of the ionode within its own pool ! IF ( ionode ) ionode_pool = me_bgrp ! CALL mp_bcast( ionode_pool, ionode_id, intra_image_comm ) ! ! ... find out the owner of each "z" plane ! ! !IF (nproc_bgrp > 1) THEN ! DO i = 1, nproc_bgrp ! ! ! kowner( (dfftp%ipp(i)+1):(dfftp%ipp(i)+dfftp%npp(i)) ) = i - 1 ! ! ! END DO !ELSE ! kowner = ionode_id !ENDIF ldr = dfftp%nr1x*dfftp%nr2x ! ! ! Each processor is on standby to send its plane to ionode DO i1 = 1, dfftp%nr1 ! DO i2 = 1, dfftp%nr2 ! !Parallel gather of Z plane rho_plane(:)=0 DO i = 1, nproc_bgrp rho_temp(:)=0 IF( (i-1) == me_bgrp ) THEN ! ! DO i3=1, dfftp%npp(i) ! rho_temp(i3) = rho(i1+(i2-1)*dfftp%nr1x+(i3-1)*ldr) ! ! ENDDO !print *, "get 1=",rho_plane(1)," 2=",rho_plane(2)," ",dfftp%npp(i),"=",rho_plane(dfftp%npp(i)) ENDIF !call mp_barrier( world_comm ) IF ( my_bgrp_id == iopool_id ) & !Send plane to ionode ! Send and recieve rho_plane, CALL mp_get( rho_temp, rho_temp, & me_bgrp, ionode_pool, (i-1), i-1, intra_bgrp_comm ) ! !call mp_barrier( world_comm ) IF(ionode) THEN rho_plane( (dfftp%ipp(i)+1):(dfftp%ipp(i)+dfftp%npp(i)) ) = rho_temp(1:dfftp%npp(i)) !print *, "get (",dfftp%ipp(i)+1,")=",rho_plane(dfftp%ipp(i)+1)," (",dfftp%ipp(i)+dfftp%npp(i),")=",rho_plane(dfftp%ipp(i)+dfftp%npp(i)) !print *, "data of proc ",i," written I2=",i2,"I1=",i1 ENDIF ENDDO ! End of parallel send IF (ionode) THEN DO i3=1, dfftp%nr3 six_count=six_count+1 WRITE(158,'(E13.5)',advance='no') rho_plane(i3) IF (six_count == 6 ) THEN WRITE(158,'("")') six_count=0 ENDIF !print *, rho_plane(i3) ENDDO ENDIF CALL mp_barrier( world_comm ) ENDDO ENDDO ! DEALLOCATE( rho_plane ) DEALLOCATE( rho_temp ) IF (ionode) CLOSE(158) CALL mp_barrier( world_comm ) #else ! ! filename = trim(prefix) // "-" // identifier // "-pol" //trim(int_to_char(LR_polarization))// ".cube" WRITE(stdout,'(/5X,"Writing Cube file for response charge density")') !write(stdout, *) filename !write(stdout,'(5X,"|rho|=",D15.8)') rho_sum OPEN (158, file = filename, form = 'formatted', status = 'replace', err=501) !C WRITE A FORMATTED 'DENSITY-STYLE' CUBEFILE VERY SIMILAR !C TO THOSE CREATED BY THE GAUSSIAN PROGRAM OR THE CUBEGEN UTILITY. !C THE FORMAT IS AS FOLLOWS (LAST CHECKED AGAINST GAUSSIAN 98): !C !C LINE FORMAT CONTENTS !C =============================================================== !C 1 A TITLE !C 2 A DESCRIPTION OF PROPERTY STORED IN CUBEFILE !C 3 I5,3F12.6 #ATOMS, X-,Y-,Z-COORDINATES OF ORIGIN !C 4-6 I5,3F12.6 #GRIDPOINTS, INCREMENT VECTOR !C #ATOMS LINES OF ATOM COORDINATES: !C ... I5,4F12.6 ATOM NUMBER, CHARGE, X-,Y-,Z-COORDINATE !C REST: 6E13.5 CUBE DATA !C !C ALL COORDINATES ARE GIVEN IN ATOMIC UNITS. WRITE(158,*) 'Cubefile created from TDDFPT calculation' WRITE(158,*) identifier ! origin is forced to (0.0,0.0,0.0) WRITE(158,'(I5,3F12.6)') nat, 0.0d0, 0.0d0, 0.0d0 WRITE(158,'(I5,3F12.6)') dfftp%nr1, (alat*at(i,1)/dble(dfftp%nr1),i=1,3) WRITE(158,'(I5,3F12.6)') dfftp%nr2, (alat*at(i,2)/dble(dfftp%nr2),i=1,3) WRITE(158,'(I5,3F12.6)') dfftp%nr3, (alat*at(i,3)/dble(dfftp%nr3),i=1,3) DO i=1,nat nt = ityp(i) ! find atomic number for this atom. at_num = atomic_number(trim(atm(nt))) at_chrg= dble(at_num) ! at_chrg could be alternatively set to valence charge ! positions are in cartesian coordinates and a.u. ! ! wrap coordinates back into cell. tpos = matmul( transpose(bg), tau(:,i) ) tpos = tpos - nint(tpos - 0.5d0) inpos = alat * matmul( at, tpos ) WRITE(158,'(I5,5F12.6)') at_num, at_chrg, inpos ENDDO i=0 DO i1=1,dfftp%nr1 DO i2=1,dfftp%nr2 DO i3=1,dfftp%nr3 !i(i3-1)*dfftp%nr1x*dfftp%nr2x+(i2-1)*dfftp%nr1x+(i1-1)+1 i=i+1 WRITE(158,'(E13.5)',advance='no') (rho((i3-1)*dfftp%nr1x*dfftp%nr2x+(i2-1)*dfftp%nr1x+i1)) IF (i == 6 ) THEN WRITE(158,'("")') i=0 ENDIF ENDDO ENDDO ENDDO CLOSE(158) ! ! #endif CALL stop_clock( 'post-processing' ) RETURN ! 501 CALL errore ('lr_dump_rho_tot_cube', 'Unable to open file for writing', 1 ) !----------------------------------------------------------------------- END SUBROUTINE lr_dump_rho_tot_cube !----------------------------------------------------------------------- SUBROUTINE lr_dump_rho_tot_xyzd(rho,identifier) ! dump a density file in the x y z density format. !----------------------------------------------------------------------- USE io_files, ONLY : prefix USE lr_variables, ONLY : LR_polarization, LR_iteration, cube_save USE cell_base USE ions_base, ONLY : nat, ityp, atm, ntyp => nsp, tau USE mp, ONLY : mp_barrier, mp_sum, mp_bcast, mp_get USE mp_world, ONLY : world_comm USE mp_global, ONLY : me_image, intra_image_comm, me_bgrp, & nproc_bgrp, intra_bgrp_comm, my_bgrp_id USE constants, ONLY : BOHR_RADIUS_ANGS USE fft_base, ONLY : dfftp !this contains dfftp%npp (number of z planes per processor ! and dfftp%ipp (offset of the first z plane of the processor ! IMPLICIT NONE ! real (kind=dp), INTENT(in) :: rho(:) CHARACTER(len=10), INTENT(in) :: identifier ! CHARACTER(len=80) :: filename ! CHARACTER(len=6), EXTERNAL :: int_to_char ! !Local INTEGER :: i, nt, i1, i2, i3, at_num, iopool_id,ldr,kk,ionode_pool REAL(DP), ALLOCATABLE :: rho_plane(:) INTEGER, ALLOCATABLE :: kowner(:) REAL(DP) :: tpos(3), inpos(3) INTEGER, EXTERNAL:: atomic_number ! CALL start_clock( 'post-processing' ) IF (lr_verbosity > 5) WRITE(stdout,'("")') ! #ifdef __MPI !Derived From Modules/xml_io_base.f90 ALLOCATE( rho_plane( dfftp%nr1*dfftp%nr2 ) ) ALLOCATE( kowner( dfftp%nr3 ) ) IF (ionode) THEN filename = trim(prefix) // "-" // identifier // "-pol" //trim(int_to_char(LR_polarization))// ".xyzd" WRITE(stdout,'(/5X,"Writing xyzd file for response charge density")') !write(stdout, *) filename !write(stdout,'(5X,"|rho|=",D15.8)') rho_sum OPEN (158, file = filename, form = 'formatted', status = 'replace', err=501) WRITE(158,'("#NAT=",I5)') nat WRITE(158,'("#NR1=",I5,"at1=",3F12.6)') dfftp%nr1, (alat*at(i,1)/dble(dfftp%nr1),i=1,3) WRITE(158,'("#NR2=",I5,"at2=",3F12.6)') dfftp%nr2, (alat*at(i,2)/dble(dfftp%nr2),i=1,3) WRITE(158,'("#NR3=",I5,"at3=",3F12.6)') dfftp%nr3, (alat*at(i,3)/dble(dfftp%nr3),i=1,3) DO i=1,nat ! wrap coordinates back into cell. tpos = matmul( transpose(bg), tau(:,i) ) tpos = tpos - nint(tpos - 0.5d0) inpos = alat * matmul( at, tpos ) WRITE(158,'("#",A3,1X,I5,1X,3F12.6)') & atm(ityp(i)), atomic_number(trim(atm(ityp(i)))), inpos ENDDO ENDIF ! ! ... find the index of the pool that will write rho ! IF ( ionode ) iopool_id = my_bgrp_id ! CALL mp_bcast( iopool_id, ionode_id, intra_image_comm ) ! ! ... find the index of the ionode within its own pool ! IF ( ionode ) ionode_pool = me_bgrp ! CALL mp_bcast( ionode_pool, ionode_id, intra_image_comm ) ! ! ... find out the owner of each "z" plane ! ! IF (nproc_bgrp > 1) THEN DO i = 1, nproc_bgrp ! kowner( (dfftp%ipp(i)+1):(dfftp%ipp(i)+dfftp%npp(i)) ) = i - 1 ! ENDDO ELSE kowner = ionode_id ENDIF ldr = dfftp%nr1x*dfftp%nr2x ! ! ! Each processor is on standby to send its plane to ionode ! DO i3 = 1, dfftp%nr3 ! IF( kowner(i3) == me_bgrp ) THEN ! kk = i3 ! IF ( nproc_bgrp > 1 ) kk = i3 - dfftp%ipp(me_bgrp+1) ! DO i2 = 1, dfftp%nr2 ! DO i1 = 1, dfftp%nr1 ! rho_plane(i1+(i2-1)*dfftp%nr1) = rho(i1+(i2-1)& &*dfftp%nr1x+(kk-1)*ldr) ! ENDDO ! ENDDO ! ENDIF !Send plane to ionode IF ( kowner(i3) /= ionode_pool .and. my_bgrp_id == iopool_id ) & CALL mp_get( rho_plane, rho_plane, me_bgrp, ionode_pool,& & kowner(i3), i3, intra_bgrp_comm ) ! ! write IF ( ionode ) THEN DO i2 = 1, dfftp%nr2 ! DO i1 = 1, dfftp%nr1 ! WRITE(158,'(f15.8,3X)', advance='no') (DBLE(i1-1)& &*(alat*BOHR_RADIUS_ANGS*(at(1,1)+at(2,1)+at(3& &,1))/DBLE(dfftp%nr1-1))) WRITE(158,'(f15.8,3X)', advance='no') (DBLE(i2-1)& &*(alat*BOHR_RADIUS_ANGS*(at(1,2)+at(2,2)+at(3& &,2))/DBLE(dfftp%nr2-1))) WRITE(158,'(f15.8,3X)', advance='no') (DBLE(i3-1)& &*(alat*BOHR_RADIUS_ANGS*(at(1,3)+at(2,3)+at(3& &,3))/DBLE(dfftp%nr3-1))) WRITE(158,'(e13.5)') rho_plane((i2-1)*dfftp%nr1+i1) ENDDO ENDDO ENDIF ! ENDDO ! DEALLOCATE( rho_plane ) DEALLOCATE( kowner ) IF (ionode) CLOSE(158) #else ! ! filename = TRIM(prefix) // "-" // identifier // "-pol" & &//TRIM(int_to_char(LR_polarization))// ".xyzd" WRITE(stdout,'(/5X,"Writing xyzd file for response charge density")') !write(stdout, *) filename !write(stdout,'(5X,"|rho|=",D15.8)') rho_sum OPEN (158, file = filename, form = 'formatted', status = 'replace', err=501) WRITE(158,*) "# x y z density" DO i3=0,(dfftp%nr3-1) DO i2=0,(dfftp%nr2-1) DO i1=0,(dfftp%nr1-1) WRITE(158,'(f15.8,3X)', advance='no') (DBLE(i1)*(alat& &*BOHR_RADIUS_ANGS*(at(1,1)+at(2,1)+at(3,1))& &/DBLE(dfftp%nr1-1))) WRITE(158,'(f15.8,3X)', advance='no') (DBLE(i2)*(alat& &*BOHR_RADIUS_ANGS*(at(1,2)+at(2,2)+at(3,2))& &/DBLE(dfftp%nr2-1))) WRITE(158,'(f15.8,3X)', advance='no') (DBLE(i3)*(alat& &*BOHR_RADIUS_ANGS*(at(1,3)+at(2,3)+at(3,3))& &/DBLE(dfftp%nr3-1))) WRITE(158,'(e13.5)') & &rho(i3*dfftp%nr1*dfftp%nr2+i2*dfftp%nr1+i1+1) ENDDO ENDDO ENDDO CLOSE(158) ! ! #endif CALL stop_clock( 'post-processing' ) RETURN ! 501 CALL errore ('lr_dump_rho_tot_xyzd', 'Unable to open file for writing', 1 ) !----------------------------------------------------------------------- END SUBROUTINE lr_dump_rho_tot_xyzd !----------------------------------------------------------------------- SUBROUTINE lr_dump_rho_tot_xcrys(rho, identifier) !--------------------------------------------------------------------------- ! This routine dumps the charge density in xcrysden format, copyright information from ! the derived routines follows !--------------------------------------------------------------------------- ! Copyright (C) 2003 Tone Kokalj ! This file is distributed under the terms of the ! GNU General Public License. See the file `License' ! in the root directory of the present distribution, ! or http://www.gnu.org/copyleft/gpl.txt . ! ! This file holds XSF (=Xcrysden Structure File) utilities. ! Routines written by Tone Kokalj on Mon Jan 27 18:51:17 CET 2003 ! ! ------------------------------------------------------------------- ! this routine writes the crystal structure in XSF format ! ------------------------------------------------------------------- ! ------------------------------------------------------------------- ! this routine writes the 3D scalar field (i.e. uniform mesh of points) ! in XSF format using the FFT mesh (i.e. fast write) ! ------------------------------------------------------------------- USE constants, ONLY : BOHR_RADIUS_ANGS USE io_files, ONLY : prefix USE lr_variables, ONLY : LR_polarization, LR_iteration, cube_save USE cell_base USE ions_base, ONLY : nat, ityp, atm, ntyp => nsp, tau USE mp, ONLY : mp_barrier, mp_sum, mp_bcast, mp_get USE mp_world, ONLY : world_comm USE mp_global, ONLY : me_image, intra_image_comm, me_bgrp, nproc_bgrp, & intra_bgrp_comm, my_bgrp_id USE constants, ONLY : BOHR_RADIUS_ANGS USE fft_base, ONLY : dfftp !this contains dfftp%npp (number of z planes per processor ! and dfftp%ipp (offset of the first z plane of the processor IMPLICIT NONE ! real (kind=dp), INTENT(in) :: rho(:) CHARACTER(len=10), INTENT(in) :: identifier ! INTERNAL CHARACTER(len=80) :: filename ! -- INTEGER :: i, j, n INTEGER :: i1, i2, i3, ix, iy, iz, count, & ind_x(10), ind_y(10),ind_z(10) real(DP) :: at1 (3, 3) CHARACTER(len=6), EXTERNAL :: int_to_char !Local INTEGER :: iopool_id,ldr,kk,ionode_pool,six_count REAL(DP), ALLOCATABLE :: rho_plane(:) INTEGER, ALLOCATABLE :: kowner(:) ! six_count=0 CALL start_clock( 'post-processing' ) IF (lr_verbosity > 5) WRITE(stdout,'("")') #ifdef __MPI IF (ionode) THEN ! ! filename = trim(prefix) // "-" // identifier // "-pol" //trim(int_to_char(LR_polarization))// ".xsf" WRITE(stdout,'(/5X,"Writing xsf file for response charge density")') !write(stdout, *) filename OPEN (158, file = filename, form = 'formatted', status = 'replace', err=501) ! convert lattice vectors to ANGSTROM units ... DO i=1,3 DO j=1,3 at1(j,i) = at(j,i)*alat*BOHR_RADIUS_ANGS ENDDO ENDDO WRITE(158,*) 'CRYSTAL' WRITE(158,*) 'PRIMVEC' WRITE(158,'(2(3F15.9/),3f15.9)') at1 WRITE(158,*) 'PRIMCOORD' WRITE(158,*) nat, 1 DO n=1,nat ! positions are in Angstroms WRITE(158,'(a3,3x,3f15.9)') atm(ityp(n)), & tau(1,n)*alat*BOHR_RADIUS_ANGS, & tau(2,n)*alat*BOHR_RADIUS_ANGS, & tau(3,n)*alat*BOHR_RADIUS_ANGS ENDDO ! -- ! XSF scalar-field header WRITE(158,'(a)') 'BEGIN_BLOCK_DATAGRID_3D' WRITE(158,'(a)') '3D_PWSCF' WRITE(158,'(a)') 'DATAGRID_3D_UNKNOWN' ! number of points in each direction WRITE(158,*) dfftp%nr1+1, dfftp%nr2+1, dfftp%nr3+1 ! origin WRITE(158,'(3f10.6)') 0.0d0, 0.0d0, 0.0d0 ! 1st spanning (=lattice) vector WRITE(158,'(3f10.6)') (BOHR_RADIUS_ANGS*alat*at(i,1),i=1,3) ! in ANSTROMS ! 2nd spanning (=lattice) vector WRITE(158,'(3f10.6)') (BOHR_RADIUS_ANGS*alat*at(i,2),i=1,3) ! 3rd spanning (=lattice) vector WRITE(158,'(3f10.6)') (BOHR_RADIUS_ANGS*alat*at(i,3),i=1,3) ENDIF ALLOCATE( rho_plane( dfftp%nr1*dfftp%nr2 ) ) ALLOCATE( kowner( dfftp%nr3 ) ) ! ! ... find the index of the pool that will write rho ! IF ( ionode ) iopool_id = my_bgrp_id ! CALL mp_bcast( iopool_id, ionode_id, intra_image_comm ) ! ! ... find the index of the ionode within its own pool ! IF ( ionode ) ionode_pool = me_bgrp ! CALL mp_bcast( ionode_pool, ionode_id, intra_image_comm ) ! ! ... find out the owner of each "z" plane ! ! IF (nproc_bgrp > 1) THEN DO i = 1, nproc_bgrp ! kowner( (dfftp%ipp(i)+1):(dfftp%ipp(i)+dfftp%npp(i)) ) = i - 1 ! ENDDO ELSE kowner = ionode_id ENDIF ldr = dfftp%nr1x*dfftp%nr2x ! ! ! Each processor is on standby to send its plane to ionode ! DO i3 = 1, dfftp%nr3 ! IF( kowner(i3) == me_bgrp ) THEN ! kk = i3 ! IF ( nproc_bgrp > 1 ) kk = i3 - dfftp%ipp(me_bgrp+1) ! DO i2 = 1, dfftp%nr2 ! DO i1 = 1, dfftp%nr1 ! rho_plane(i1+(i2-1)*dfftp%nr1) = rho(i1+(i2-1)*dfftp%nr1x+(kk-1)*ldr) ! ENDDO ! ENDDO ! ENDIF !Send plane to ionode IF ( kowner(i3) /= ionode_pool .and. my_bgrp_id == iopool_id ) & CALL mp_get( rho_plane, rho_plane, & me_bgrp, ionode_pool, kowner(i3), i3, intra_bgrp_comm ) ! ! write IF ( ionode ) THEN DO i2 = 1, dfftp%nr2 ! DO i1 = 1, dfftp%nr1 six_count=six_count+1 WRITE(158,'(e13.5)',advance='no') rho_plane((i2-1)*dfftp%nr1+i1) IF (six_count == 6 ) THEN WRITE(158,'("")') six_count=0 ENDIF ENDDO ENDDO ENDIF ! ENDDO ! DEALLOCATE( rho_plane ) DEALLOCATE( kowner ) IF (ionode) CLOSE(158) #else ! ! filename = trim(prefix) // "-" // identifier // "-pol" //trim(int_to_char(LR_polarization))// ".xsf" WRITE(stdout,'(/5X,"Writing xsf file for response charge density")') !write(stdout, *) filename OPEN (158, file = filename, form = 'formatted', status = 'replace', err=501) ! convert lattice vectors to ANGSTROM units ... DO i=1,3 DO j=1,3 at1(j,i) = at(j,i)*alat*BOHR_RADIUS_ANGS ENDDO ENDDO WRITE(158,*) 'CRYSTAL' WRITE(158,*) 'PRIMVEC' WRITE(158,'(2(3F15.9/),3f15.9)') at1 WRITE(158,*) 'PRIMCOORD' WRITE(158,*) nat, 1 DO n=1,nat ! positions are in Angstroms WRITE(158,'(a3,3x,3f15.9)') atm(ityp(n)), & tau(1,n)*alat*BOHR_RADIUS_ANGS, & tau(2,n)*alat*BOHR_RADIUS_ANGS, & tau(3,n)*alat*BOHR_RADIUS_ANGS ENDDO ! -- ! XSF scalar-field header WRITE(158,'(a)') 'BEGIN_BLOCK_DATAGRID_3D' WRITE(158,'(a)') '3D_PWSCF' WRITE(158,'(a)') 'DATAGRID_3D_UNKNOWN' ! number of points in each direction WRITE(158,*) dfftp%nr1+1, dfftp%nr2+1, dfftp%nr3+1 ! origin WRITE(158,'(3f10.6)') 0.0d0, 0.0d0, 0.0d0 ! 1st spanning (=lattice) vector WRITE(158,'(3f10.6)') (BOHR_RADIUS_ANGS*alat*at(i,1),i=1,3) ! in ANSTROMS ! 2nd spanning (=lattice) vector WRITE(158,'(3f10.6)') (BOHR_RADIUS_ANGS*alat*at(i,2),i=1,3) ! 3rd spanning (=lattice) vector WRITE(158,'(3f10.6)') (BOHR_RADIUS_ANGS*alat*at(i,3),i=1,3) count=0 DO i3=0,dfftp%nr3 iz = mod(i3,dfftp%nr3) !iz = mod(i3,dfftp%nr3) + 1 DO i2=0,dfftp%nr2 iy = mod(i2,dfftp%nr2) !iy = mod(i2,dfftp%nr2) + 1 DO i1=0,dfftp%nr1 ix = mod(i1,dfftp%nr1) !ix = mod(i1,dfftp%nr1) + 1 !ii = (1+ix) + iy*dfftp%nr1x + iz*dfftp%nr1x*dfftp%nr2x IF (count<6) THEN count = count + 1 !ind(count) = ii ELSE WRITE(158,'(6e13.5)') & (rho(ind_x(i)+1+dfftp%nr1*ind_y(i)+dfftp%nr1*dfftp%nr2*ind_z(i)),i=1,6) count=1 !ind(count) = ii ENDIF ind_x(count) = ix ind_y(count) = iy ind_z(count) = iz ENDDO ENDDO ENDDO WRITE(158,'(6e13.5:)') (rho(ind_x(i)+1+dfftp%nr1*ind_y(i)+dfftp%nr1*dfftp%nr2*ind_z(i)),i=1,count) WRITE(158,'(a)') 'END_DATAGRID_3D' WRITE(158,'(a)') 'END_BLOCK_DATAGRID_3D' #endif CALL stop_clock( 'post-processing' ) RETURN ! 501 CALL errore ('lr_dump_rho_tot_xyzd', 'Unable to open file for writing', 1 ) !----------------------------------------------------------------------- END SUBROUTINE lr_dump_rho_tot_xcrys !----------------------------------------------------------------------- !----------------------------------------------------------------------- SUBROUTINE lr_dump_rho_tot_pxyd(rho,identifier) !----------------------------------------------------------------------- ! dump a density file in the x y plane density summed over z planes format. !----------------------------------------------------------------------- USE io_files, ONLY : prefix USE lr_variables, ONLY : LR_polarization, LR_iteration, cube_save USE fft_base, ONLY : dfftp USE cell_base USE ions_base, ONLY : nat, ityp, atm, ntyp => nsp, tau USE mp, ONLY : mp_barrier, mp_sum USE mp_world, ONLY : world_comm USE mp_global, ONLY : intra_bgrp_comm USE constants, ONLY : BOHR_RADIUS_ANGS ! IMPLICIT NONE ! real (kind=dp), INTENT(in) :: rho(:) CHARACTER(len=10), INTENT(in) :: identifier ! CHARACTER(len=80) :: filename ! CHARACTER(len=6), EXTERNAL :: int_to_char ! !Local INTEGER :: i, nt, i1, i2, i3, at_num INTEGER, EXTERNAL:: atomic_number real(DP) :: at_chrg, tpos(3), inpos(3),rho_sum ! CALL start_clock( 'post-processing' ) IF (lr_verbosity > 5) WRITE(stdout,'("")') rho_sum=0.0d0 DO i=1,dfftp%nnr rho_sum=rho_sum+rho(i) ENDDO ! #ifdef __MPI IF (ionode) THEN #endif ! ! filename = trim(prefix) // "-" // identifier // "-pol" //trim(int_to_char(LR_polarization))// ".pxyd" WRITE(stdout,'(/5X,"Writing z plane averaged pxyd file for response charge density")') !write(stdout, *) filename WRITE(stdout,'(5X,"|rho|=",D15.8)') rho_sum OPEN (158, file = filename, form = 'formatted', status = 'replace', err=501) WRITE(158,*) "# x y z density" DO i1=0,(dfftp%nr1-1) DO i2=0,(dfftp%nr2-1) rho_sum=0 DO i3=0,(dfftp%nr3-1) rho_sum=rho_sum+rho(i3*dfftp%nr1*dfftp%nr2+i2*dfftp%nr1+i1+1) ENDDO WRITE(158,'(f15.8,3X)', advance='no') (dble(i1)*(alat*BOHR_RADIUS_ANGS*(at(1,1)+at(2,1)+at(3,1))/dble(dfftp%nr1-1))) WRITE(158,'(f15.8,3X)', advance='no') (dble(i2)*(alat*BOHR_RADIUS_ANGS*(at(1,2)+at(2,2)+at(3,2))/dble(dfftp%nr2-1))) WRITE(158,'(e13.5)') rho_sum ENDDO ENDDO CLOSE(158) ! ! #ifdef __MPI ENDIF CALL mp_barrier(world_comm) #endif CALL stop_clock( 'post-processing' ) RETURN ! 501 CALL errore ('lr_dump_rho_tot_pxyd', 'Unable to open file for writing', 1 ) !----------------------------------------------------------------------- END SUBROUTINE lr_dump_rho_tot_pxyd END MODULE charg_resp TDDFPT/src/print_clock_lr.f900000755000175000017500000000765312341371472014260 0ustar mbamba! ! Copyright (C) 2001-2006 Quantum ESPRESSO group ! This file is distributed under the terms of the ! GNU General Public License. See the file `License' ! in the root directory of the present distribution, ! or http://www.gnu.org/copyleft/gpl.txt . ! !---------------------------------------------------------------------------- !OBM ! 160608 reduce clocks removed SUBROUTINE print_clock_lr() !--------------------------------------------------------------------------- ! ! ... this routine prints out the clocks at the end of the run ! ... it tries to construct the calling tree of the program. ! ! Modified by Osman Baris Malcioglu (2009) USE io_global, ONLY : stdout USE mp_world, ONLY : mpime, root USE realus, ONLY : real_space,real_space_debug use lr_variables, only : davidson #ifdef __ENVIRON USE plugin_flags, ONLY : use_environ USE environ_info, ONLY : environ_clock #endif ! IMPLICIT NONE ! ! IF ( mpime /= root ) & OPEN( UNIT = stdout, FILE = '/dev/null', STATUS = 'UNKNOWN' ) ! WRITE( stdout, * ) ! if(.not. davidson) CALL print_clock( 'lr_main' ) if(davidson) CALL print_clock( 'lr_dav_main' ) CALL print_clock( 'read_wf' ) CALL print_clock( 'lr_solve_e' ) if(davidson) then CALL print_clock( 'calc_residue' ) CALL print_clock( 'expan_basis' ) endif CALL print_clock( 'one_step' ) ! WRITE( stdout, * ) call print_clock('matrix') WRITE( stdout, * ) ! CALL print_clock('lr_apply') CALL print_clock('lr_apply_int') CALL print_clock('lr_apply_no') if(davidson) then CALL print_clock( 'mGS_orth' ) CALL print_clock( 'mGS_orth_pp' ) endif ! WRITE( stdout, * ) ! CALL print_clock( 'lr_apply' ) CALL print_clock( 'h_psi' ) CALL print_clock('lr_exx_noint') CALL print_clock( 'lr_calc_dens' ) CALL print_clock( 'lr_addusdens' ) CALL print_clock( 'lr_dv' ) CALL print_clock( 'lr_ortho' ) CALL print_clock( 'interaction' ) CALL print_clock( 'lr_dot' ) ! WRITE( stdout, * ) CALL print_clock( 'lr_calc_dens' ) CALL print_clock('lr_exx_int') ! WRITE( stdout, * ) WRITE( stdout, '(5X,"US routines")' ) ! CALL print_clock( 's_psi' ) CALL print_clock( 'lr_sm1_psi' ) ! !WRITE( stdout, * ) !WRITE( stdout, '(5X,"OBM DEBUG")' ) !CALL print_clock( 'lrcd-lp1' ) !CALL print_clock( 'lrcd-us' ) !CALL print_clock( 'lrcd_sp' ) !CALL print_clock( 'lrcd_usdens' ) ! IF (real_space_debug>0) THEN WRITE( stdout, '(5X,"US routines, RS")' ) CALL print_clock ( 'realus' ) CALL print_clock ( 'betapointlist' ) CALL print_clock ( 'calbec_rs' ) CALL print_clock ( 's_psir' ) CALL print_clock ( 'add_vuspsir' ) CALL print_clock ( 'fft_orbital' ) CALL print_clock ( 'bfft_orbital' ) CALL print_clock ( 'v_loc_psir' ) ENDIF ! WRITE( stdout, * ) WRITE( stdout, '(5X,"General routines")' ) ! CALL print_clock( 'calbec' ) CALL print_clock( 'fft' ) CALL print_clock( 'ffts' ) CALL print_clock( 'fftc' ) CALL print_clock( 'fftw' ) CALL print_clock( 'fftcw' ) CALL print_clock( 'interpolate' ) CALL print_clock( 'davcio' ) CALL print_clock( 'newq' ) CALL print_clock ( 'addusdens' ) ! ! WRITE( stdout, * ) ! #if defined (__MPI) WRITE( stdout, '(5X,"Parallel routines")' ) ! !CALL print_clock( 'reduce' ) CALL print_clock( 'fft_scatter' ) !CALL print_clock( 'poolreduce' ) CALL print_clock ('mp_sum') WRITE( stdout, * ) #endif ! #ifdef __ENVIRON IF ( use_environ ) CALL environ_clock( stdout ) #endif ! WRITE( stdout, '(5X,"EXX routines")' ) ! CALL print_clock( 'exx_grid' ) CALL print_clock( 'exxinit' ) CALL print_clock( 'vexx' ) CALL print_clock( 'exxenergy' ) CALL print_clock( 'exxen2' ) CALL print_clock ('cycleig') ! CALL print_clock( 'post-processing' ) RETURN ! END SUBROUTINE print_clock_lr TDDFPT/src/stop_lr.f900000755000175000017500000000607712341371472012735 0ustar mbamba! ! Copyright (C) 2004-2013 Quantum ESPRESSO group ! This file is distributed under the terms of the ! GNU General Public License. See the file `License' ! in the root directory of the present distribution, ! or http://www.gnu.org/copyleft/gpl.txt . ! !-------------------------------------------------------------------- SUBROUTINE stop_lr( full_run ) !---------------------------------------------------------------------------- ! ! ... Synchronize processes before stopping. ! ! Modified by O. Baris Malcioglu (2009) USE kinds, ONLY : DP USE mp_global, ONLY : mp_global_end ! USE parallel_include USE lr_variables, ONLY : n_ipol, LR_polarization, beta_store USE lr_variables, ONLY : gamma_store, zeta_store, norm0, code USE lr_variables, ONLY : lr_verbosity, itermax, bgz_suffix USE io_global, ONLY : ionode USE io_files, ONLY : tmp_dir, prefix USE io_global, ONLY : stdout USE environment, ONLY : environment_end ! For gaussian cube file USE ions_base, ONLY : nat, ityp, atm, ntyp => nsp, tau USE cell_base, ONLY : celldm, at, bg #ifdef __ENVIRON USE plugin_flags, ONLY : use_environ USE solvent_tddfpt, ONLY : solvent_clean_tddfpt #endif ! IMPLICIT NONE ! LOGICAL, INTENT(IN) :: full_run ! CHARACTER(len=6), EXTERNAL :: int_to_char ! CHARACTER(len=256) :: filename ! INTEGER :: ip,i,j ! ! IF (lr_verbosity > 5) THEN WRITE(stdout,'("")') ENDIF ! I write the beta gamma and z coefficents to output directory for ! easier post processing. These can also be read from the output log file IF(full_run) THEN #ifdef __MPI IF (ionode) THEN #endif ! DO ip=1,n_ipol IF (n_ipol==3) filename = trim(prefix) // trim(bgz_suffix) // trim(int_to_char(ip)) IF (n_ipol==1) filename = trim(prefix) // trim(bgz_suffix) // trim(int_to_char(LR_polarization)) filename = trim(tmp_dir) // trim(filename) ! ! OPEN (158, file = filename, form = 'formatted', status = 'replace') ! WRITE(158,*) itermax ! norm0(ip)=beta_store(ip,1) WRITE(158,*) norm0(ip) ! DO i=1,itermax-1 ! WRITE(158,*) beta_store(ip,i+1) WRITE(158,*) gamma_store(ip,i+1) !This is absolutely necessary for cross platform compatibilty DO j=1,n_ipol WRITE(158,*) zeta_store (ip,j,i) ENDDO ! ENDDO WRITE(158,*) beta_store(ip,itermax) ! XC: This two faked values will not be WRITE(158,*) gamma_store(ip,itermax) ! really used in spectrum calculation DO j=1,n_ipol WRITE(158,*) zeta_store (ip,j,itermax) ENDDO ! CLOSE(158) ! ENDDO #ifdef __MPI ENDIF #endif ENDIF ! ! Deallocate lr variables ! CALL lr_dealloc() ! #ifdef __ENVIRON ! ! Deallocate Environ related arrays ! IF (use_environ) CALL solvent_clean_tddfpt() ! #endif ! CALL environment_end(code) ! CALL mp_global_end( ) ! #if defined (__T3E) ! ! ... set streambuffers off ! CALL set_d_stream( 0 ) ! #endif ! STOP ! ! END SUBROUTINE stop_lr TDDFPT/src/lr_ortho.f900000755000175000017500000002737412341371472013106 0ustar mbamba! ! Copyright (C) 2008 Quantum ESPRESSO group ! This file is distributed under the terms of the ! GNU General Public License. See the file `License' ! in the root directory of the present distribution, ! or http://www.gnu.org/copyleft/gpl.txt . ! ! !----------------------------------------------------------------------- ! Modified by Osman Baris Malcioglu (2009) SUBROUTINE lr_ortho(dvpsi, evq, ikk, ikq, sevc, inverse) !subroutine lr_ortho(sv) ! ! ! This routine ortogonalizes dvpsi to the valence states: ps = ! It should be quite general. It works for metals and insulators, with ! NC as well as with US PP, both SR or FR. ! Note that on output it changes sign. So it applies -P^+_c. ! !OBM!! evc0 ->evq sevc0 -> sevc dvpsi -> input/output ! USE kinds, ONLY : DP USE gvect, ONLY : gstart USE klist, ONLY : lgauss, degauss, ngauss USE noncollin_module, ONLY : noncolin, npol USE wvfct, ONLY : npwx, nbnd, et USE ener, ONLY : ef !USE qpoint, ONLY : npwq USE control_ph, ONLY : alpha_pv, nbnd_occ !USE becmod, ONLY : becp, becp_nc, calbec USE uspp, ONLY : vkb, okvan USE mp_global, ONLY : intra_bgrp_comm USE mp, ONLY : mp_sum !use lr_variables, ONLY : lr_alpha_pv, nbnd_occ, USE lr_variables, ONLY : lr_verbosity USE realus, ONLY : npw_k USE control_flags, ONLY : gamma_only USE io_global, ONLY : stdout ! IMPLICIT NONE INTEGER, INTENT(in) :: ikk, ikq ! the index of the k and k+q points COMPLEX(DP), INTENT(in) :: evq(npwx*npol,nbnd) COMPLEX(DP), INTENT(inout) :: dvpsi(npwx*npol,nbnd) COMPLEX(DP), INTENT(in) :: sevc(npwx*npol,nbnd) ! work space allocated by ! the calling routine (was called dpsi) !real(kind=dp), intent(IN) :: lr_alpha_pv !This is calculated manually in tddfpt LOGICAL, INTENT(in):: inverse !if .true. |dvspi> = |dvpsi> - |evq> instead of |dvspi> = |dvpsi> - |sevc> LOGICAL:: inverse_mode ! functions computing the delta and theta function CALL start_clock ('lr_ortho') IF (lr_verbosity > 5) WRITE(stdout,'("")') ! !if (.not. present(inverse)) then ! inverse_mode=.false. !else inverse_mode=inverse !endif IF (gamma_only) THEN ! CALL lr_ortho_gamma() ! ELSEIF (noncolin) THEN ! CALL lr_ortho_noncolin() ! ELSE ! CALL lr_ortho_k() ! ENDIF CALL stop_clock ('lr_ortho') RETURN CONTAINS !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! ! !multiple K point specific ! !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! SUBROUTINE lr_ortho_k() IMPLICIT NONE COMPLEX(DP), ALLOCATABLE :: ps(:,:) INTEGER :: ibnd, jbnd, nbnd_eff REAL(DP) :: wg1, w0g, wgp, wwg, deltae, theta REAL(DP), EXTERNAL :: w0gauss, wgauss ALLOCATE(ps(nbnd,nbnd)) ! IF (lgauss) THEN ! ! metallic case ! ps = (0.d0, 0.d0) IF (inverse_mode) THEN CALL ZGEMM( 'C', 'N', nbnd, nbnd_occ (ikk), npw_k(ikk), (1.d0,0.d0), & sevc, npwx, dvpsi, npwx, (0.d0,0.d0), ps, nbnd ) ELSE CALL ZGEMM( 'C', 'N', nbnd, nbnd_occ (ikk), npw_k(ikk), (1.d0,0.d0), & evq, npwx, dvpsi, npwx, (0.d0,0.d0), ps, nbnd ) ENDIF ! DO ibnd = 1, nbnd_occ (ikk) wg1 = wgauss ((ef-et(ibnd,ikk)) / degauss, ngauss) w0g = w0gauss((ef-et(ibnd,ikk)) / degauss, ngauss) / degauss DO jbnd = 1, nbnd wgp = wgauss ( (ef - et (jbnd, ikq) ) / degauss, ngauss) deltae = et (jbnd, ikq) - et (ibnd, ikk) theta = wgauss (deltae / degauss, 0) wwg = wg1 * (1.d0 - theta) + wgp * theta IF (jbnd <= nbnd_occ (ikq) ) THEN IF (abs (deltae) > 1.0d-5) THEN wwg = wwg + alpha_pv * theta * (wgp - wg1) / deltae ELSE ! ! if the two energies are too close takes the limit ! of the 0/0 ratio ! wwg = wwg - alpha_pv * theta * w0g ENDIF ENDIF ! ps(jbnd,ibnd) = wwg * ps(jbnd,ibnd) ! ENDDO CALL DSCAL (2*npw_k(ikk), wg1, dvpsi(1,ibnd), 1) ENDDO nbnd_eff=nbnd ELSE ! ! insulators ! ps = (0.d0, 0.d0) !OBM!!! !ps = ! in the old version it was IF (inverse_mode) THEN CALL ZGEMM( 'C', 'N', nbnd_occ(ikq), nbnd_occ (ikk), npw_k(ikk), & (1.d0,0.d0), sevc, npwx, dvpsi, npwx, & (0.d0,0.d0), ps, nbnd ) ELSE CALL ZGEMM( 'C', 'N', nbnd_occ(ikq), nbnd_occ (ikk), npw_k(ikk), & (1.d0,0.d0), evq, npwx, dvpsi, npwx, & (0.d0,0.d0), ps, nbnd ) ENDIF nbnd_eff=nbnd_occ(ikk) ENDIF #ifdef __MPI CALL mp_sum(ps(:,1:nbnd_eff),intra_bgrp_comm) #endif !! !! |dvspi> = -(|dvpsi> - |sevc>) !! !OBM!!! changed to |dvspi> = |dvpsi> - |sevc> IF (lgauss) THEN ! ! metallic case ! IF (inverse_mode) THEN CALL ZGEMM( 'N', 'N', npw_k(ikk), nbnd_occ(ikk), nbnd, & (-1.d0,0.d0), evq, npwx, ps, nbnd, (1.0d0,0.d0), & dvpsi, npwx ) ELSE CALL ZGEMM( 'N', 'N', npw_k(ikk), nbnd_occ(ikk), nbnd, & (-1.d0,0.d0), sevc, npwx, ps, nbnd, (1.0d0,0.d0), & dvpsi, npwx ) ENDIF ELSE ! ! Insulators: note that nbnd_occ(ikk)=nbnd_occ(ikq) in an insulator ! IF (inverse_mode) THEN CALL ZGEMM( 'N', 'N', npw_k(ikk), nbnd_occ(ikk), nbnd_occ(ikk), & (-1.d0,0.d0), evq, npwx, ps, nbnd, (1.0d0,0.d0), & dvpsi, npwx ) ELSE CALL ZGEMM( 'N', 'N', npw_k(ikk), nbnd_occ(ikk), nbnd_occ(ikk), & (-1.d0,0.d0), sevc, npwx, ps, nbnd, (1.0d0,0.d0), & dvpsi, npwx ) ENDIF ENDIF DEALLOCATE(ps) END SUBROUTINE lr_ortho_k !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! ! !Gamma point specific ! !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! SUBROUTINE lr_ortho_gamma() IMPLICIT NONE COMPLEX(DP), ALLOCATABLE :: ps_c(:,:) REAL(DP), ALLOCATABLE :: ps(:,:) INTEGER :: ibnd, jbnd, nbnd_eff REAL(DP) :: wg1, w0g, wgp, wwg, deltae, theta REAL(DP), EXTERNAL :: w0gauss, wgauss ALLOCATE(ps(nbnd,nbnd)) ALLOCATE(ps_c(nbnd,nbnd)) ! IF (lgauss) THEN CALL errore ('lr_ortho', "degauss with gamma point algorithms",1) ELSE ! ! insulators ! ps = ! in old version it was ps = ps = 0.d0 IF (inverse_mode) THEN CALL DGEMM( 'C', 'N', nbnd, nbnd ,2*npw_k(1), & 2.d0, sevc, 2*npwx, dvpsi, 2*npwx, & 0.d0, ps, nbnd ) !ps = 2* ELSE CALL DGEMM( 'C', 'N', nbnd, nbnd ,2*npw_k(1), & 2.d0, evq, 2*npwx, dvpsi, 2*npwx, & 0.d0, ps, nbnd ) !ps = 2* ENDIF nbnd_eff=nbnd IF (gstart == 2) THEN IF (inverse_mode) THEN CALL DGER( nbnd, nbnd, -1.D0, sevc, 2*npwx, dvpsi, 2*npwx, ps, nbnd ) !PS = PS - sevc*dvpsi ELSE CALL DGER( nbnd, nbnd, -1.D0, evq, 2*npwx, dvpsi, 2*npwx, ps, nbnd ) !PS = PS - evc*dvpsi ENDIF ENDIF ENDIF #ifdef __MPI CALL mp_sum(ps(:,:),intra_bgrp_comm) #endif ! in the original dpsi was used as a storage for sevc, since in ! tddfpt we have it stored in memory as sevc0 this part is obsolote !! !! dpsi is used as work space to store S|evc> !! !IF (noncolin) THEN ! IF (okvan) CALL calbec ( npw_k(ikk), vkb, evq, becp_nc, nbnd_eff ) !ELSE ! IF (okvan) CALL calbec ( npwq, vkb, evq, becp, nbnd_eff) !ENDIF !CALL s_psi (npwx, npwq, nbnd_eff, evq, dpsi) ps_c = cmplx(ps, 0.d0, dp) !! !! |dvspi> = -(|dvpsi> - S|evq>) !! !OBM!!! changed to |dvspi> = |dvpsi> - |sevc> IF (lgauss) THEN !errore ? ELSE ! ! Insulators: note that nbnd_occ(ikk)=nbnd_occ(ikq) in an insulator ! IF (inverse_mode) THEN CALL ZGEMM( 'N', 'N', npw_k(1), nbnd, nbnd, & (-1.d0,0.d0), evq, npwx, ps_c, nbnd, (1.0d0,0.d0), & dvpsi, npwx ) !dvpsi=dvpsi-|evq> ELSE CALL ZGEMM( 'N', 'N', npw_k(1), nbnd, nbnd, & (-1.d0,0.d0), sevc, npwx, ps_c, nbnd, (1.0d0,0.d0), & dvpsi, npwx ) !dvpsi=dvpsi-|sevc> ENDIF ENDIF DEALLOCATE(ps) DEALLOCATE(ps_c) END SUBROUTINE lr_ortho_gamma !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! ! !noncolin specific ! !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! SUBROUTINE lr_ortho_noncolin() IMPLICIT NONE COMPLEX(DP), ALLOCATABLE :: ps(:,:) INTEGER :: ibnd, jbnd, nbnd_eff REAL(DP) :: wg1, w0g, wgp, wwg, deltae, theta REAL(DP), EXTERNAL :: w0gauss, wgauss ALLOCATE(ps(nbnd,nbnd)) ! IF (lgauss) THEN ! ! metallic case ! ps = (0.d0, 0.d0) CALL ZGEMM( 'C', 'N', nbnd, nbnd_occ (ikk), npwx*npol, (1.d0,0.d0), & evq, npwx*npol, dvpsi, npwx*npol, (0.d0,0.d0), ps, nbnd ) ! DO ibnd = 1, nbnd_occ (ikk) wg1 = wgauss ((ef-et(ibnd,ikk)) / degauss, ngauss) w0g = w0gauss((ef-et(ibnd,ikk)) / degauss, ngauss) / degauss DO jbnd = 1, nbnd wgp = wgauss ( (ef - et (jbnd, ikq) ) / degauss, ngauss) deltae = et (jbnd, ikq) - et (ibnd, ikk) theta = wgauss (deltae / degauss, 0) wwg = wg1 * (1.d0 - theta) + wgp * theta IF (jbnd <= nbnd_occ (ikq) ) THEN IF (abs (deltae) > 1.0d-5) THEN wwg = wwg + alpha_pv * theta * (wgp - wg1) / deltae ELSE ! ! if the two energies are too close takes the limit ! of the 0/0 ratio ! wwg = wwg - alpha_pv * theta * w0g ENDIF ENDIF ! ps(jbnd,ibnd) = wwg * ps(jbnd,ibnd) ! ENDDO CALL DSCAL (2*npwx*npol, wg1, dvpsi(1,ibnd), 1) ENDDO nbnd_eff=nbnd ELSE ! ! insulators ! ps = (0.d0, 0.d0) CALL ZGEMM( 'C', 'N',nbnd_occ(ikq), nbnd_occ(ikk), npwx*npol, & (1.d0,0.d0), evq, npwx*npol, dvpsi, npwx*npol, & (0.d0,0.d0), ps, nbnd ) nbnd_eff=nbnd_occ(ikk) ENDIF #ifdef __MPI CALL mp_sum(ps(:,1:nbnd_eff),intra_bgrp_comm) #endif ! in the original dpsi was used as a storage for sevc, since in ! tddfpt we have it stored in memory as sevc0 this part is obsolote !! !! dpsi is used as work space to store S|evc> !! !IF (noncolin) THEN ! IF (okvan) CALL calbec ( npw_k(ikk), vkb, evq, becp_nc, nbnd_eff ) !ELSE ! IF (okvan) CALL calbec ( npwq, vkb, evq, becp, nbnd_eff) !ENDIF !CALL s_psi (npwx, npwq, nbnd_eff, evq, dpsi) !! !! |dvspi> = -(|dvpsi> - S|evq>) !OBM!!! changed to |dvspi> = |dvpsi> - S|evq> using this !! IF (lgauss) THEN ! ! metallic case ! CALL ZGEMM( 'N', 'N', npwx*npol, nbnd_occ(ikk), nbnd, & (-1.d0,0.d0), sevc, npwx*npol, ps, nbnd, (1.0d0,0.d0), & dvpsi, npwx*npol ) ELSE ! ! Insulators: note that nbnd_occ(ikk)=nbnd_occ(ikq) in an insulator ! CALL ZGEMM( 'N', 'N', npwx*npol, nbnd_occ(ikk), nbnd_occ(ikk), & (-1.d0,0.d0),sevc,npwx*npol,ps,nbnd,(1.0d0,0.d0), & dvpsi, npwx*npol ) ENDIF DEALLOCATE(ps) END SUBROUTINE lr_ortho_noncolin END SUBROUTINE lr_ortho !----------------------------------------------------------------------- TDDFPT/src/lr_normalise.f900000755000175000017500000000777112341371472013743 0ustar mbamba!----------------------------------------------------------------------- ! ... normalises the two components of a supervector so that they ! ... have an inner product of 1 !----------------------------------------------------------------------- ! Modified by Osman Baris Malcioglu (2009) SUBROUTINE lr_normalise(evc1,norm) ! ! USE kinds, ONLY : dp USE gvect, ONLY : gstart USE cell_base, ONLY : omega USE io_global, ONLY : stdout USE klist, ONLY : nks,xk USE lsda_mod, ONLY : nspin USE lr_variables, ONLY : lanc_norm USE realus, ONLY : igk_k, npw_k USE uspp, ONLY : vkb, nkb, okvan USE wvfct, ONLY : nbnd, npwx, npw, wg USE control_flags, ONLY : gamma_only USE lr_variables, ONLY : lr_verbosity ! IMPLICIT NONE ! real(kind=dp), INTENT(out) :: norm ! ! local variables INTEGER :: ik COMPLEX(kind=dp) :: evc1(npwx,nbnd,nks) COMPLEX(kind=dp), ALLOCATABLE :: spsi(:,:,:) INTEGER :: ibnd,ig ! ALLOCATE(spsi(npwx,nbnd,nks)) ! IF (lr_verbosity > 5) THEN WRITE(stdout,'("")') ENDIF IF(gamma_only) THEN CALL lr_normalise_gamma() ELSE CALL lr_normalise_k() ENDIF ! DEALLOCATE(spsi) ! RETURN ! CONTAINS ! !-------------------------------------------------------------------- SUBROUTINE lr_normalise_gamma() ! USE becmod, ONLY : bec_type, becp,calbec USE realus, ONLY : real_space, fft_orbital_gamma,& & initialisation_level,& & bfft_orbital_gamma, calbec_rs_gamma,& & add_vuspsir_gamma, v_loc_psir,& & s_psir_gamma, real_space_debug ! ! ! IMPLICIT NONE ! REAL(kind=dp) :: prod COMPLEX(kind=dp), EXTERNAL :: lr_dot INTEGER :: ibnd,ig ! prod=0.0d0 ! IF ( nkb > 0 ) THEN ! IF (real_space_debug>6) THEN ! real space & nkb > 0 ! DO ibnd=1,nbnd,2 CALL fft_orbital_gamma(evc1(:,:,1),ibnd,nbnd) CALL calbec_rs_gamma(ibnd,nbnd,becp%r) CALL s_psir_gamma(ibnd,nbnd) CALL bfft_orbital_gamma(spsi(:,:,1),ibnd,nbnd) ENDDO ! ! ELSE ! !the non real_space & nkb > 0 case ! CALL calbec(npw_k(1),vkb,evc1(:,:,1),becp) ! CALL s_psi(npwx,npw_k(1),nbnd,evc1(1,1,1),spsi) ! ! ENDIF ELSE ! The nkb == 0 part ! JUST array copying CALL s_psi(npwx,npw_k(1),nbnd,evc1(1,1,1),spsi) ! ! ! ENDIF ! prod=dble( lr_dot( evc1(1,1,1),spsi(1,1,1) ) ) prod=1.0d0/sqrt(abs(prod)) ! evc1(:,:,1)=cmplx(prod,0.0d0,dp)*evc1(:,:,1) ! WRITE(stdout,'(5X,"Norm of initial Lanczos vectors=",1x,f21.15)')& & 1.0d0/prod ! lanc_norm=1.d0/prod**2/omega norm=1.0d0/prod ! RETURN END SUBROUTINE lr_normalise_gamma !-------------------------------------------------------------------- SUBROUTINE lr_normalise_k() ! USE becmod, ONLY : becp,calbec ! real(kind=dp) :: prod COMPLEX(kind=dp), EXTERNAL :: lr_dot ! prod=0.0d0 ! DO ik=1,nks ! IF ( nkb > 0 .and. okvan) THEN ! CALL init_us_2(npw_k(ik),igk_k(1,ik),xk(1,ik),vkb) ! CALL calbec(npw_k(ik),vkb,evc1(:,:,ik),becp) ! ENDIF ! CALL s_psi(npwx,npw_k(ik),nbnd,evc1(:,:,ik),spsi(:,:,ik)) ! ENDDO ! prod=dble( lr_dot( evc1(1,1,1),spsi(1,1,1) ) ) prod=1.0d0/sqrt(abs(prod)) ! evc1(:,:,:)=cmplx(prod,0.0d0,dp)*evc1(:,:,:) ! WRITE(stdout,'(5X,"Norm of initial Lanczos vectors=",1x,f21.15)')& & 1.0d0/prod ! lanc_norm=1.d0/prod**2/omega norm=1.0d0/prod ! RETURN ! END SUBROUTINE lr_normalise_k ! END SUBROUTINE lr_normalise !----------------------------------------------------------------------- TDDFPT/src/lr_apply_liouvillian.f900000755000175000017500000005216712341371472015505 0ustar mbamba!----------------------------------------------------------------------- SUBROUTINE lr_apply_liouvillian( evc1, evc1_new, sevc1_new, interaction ) !--------------------------------------------------------------------- ! Applies linear response operator to response wavefunctions ! (H - E)*psi(k+q) + HXC ! ! Or to be more exact this routine is responsible for calculating ! L.q(i) and (L^T).p(i) ! Where q is evc1 ! It returns partial qdash(i+1) and pdash(i+1) in evc1_new. ! ! interaction=.true. corresponds to eq.(32) ! interaction=.false. corresponds to eq.(33) ! in Ralph Gebauer, Brent Walker J. Chem. Phys., 127, 164106 (2007) !--------------------------------------------------------------------- ! ! Modified by Osman Baris Malcioglu in 2009 ! USE ions_base, ONLY : ityp, nat, ntyp=>nsp USE cell_base, ONLY : tpiba2 USE fft_base, ONLY : dffts USE fft_interfaces, ONLY : fwfft USE gvecs, ONLY : nls, nlsm USE gvect, ONLY : nl, ngm, gstart, g, gg USE fft_base, ONLY : dfftp, dffts USE io_global, ONLY : stdout USE kinds, ONLY : dp USE klist, ONLY : nks, xk USE lr_variables, ONLY : evc0, revc0, rho_1, lr_verbosity,& & ltammd, size_evc, no_hxc, lr_exx, & & scissor, rho_1c,davidson USE realus, ONLY : igk_k,npw_k USE lsda_mod, ONLY : nspin USE uspp, ONLY : vkb, nkb, okvan USE uspp_param, ONLY : nhm, nh USE wavefunctions_module, ONLY : psic USE wvfct, ONLY : nbnd, npwx, igk, g2kin, et USE control_flags, ONLY : gamma_only USE realus, ONLY : real_space, fft_orbital_gamma,& & initialisation_level,& & bfft_orbital_gamma,& & calbec_rs_gamma,& & add_vuspsir_gamma, v_loc_psir,& & s_psir_gamma, real_space_debug,& & betasave, box_beta, maxbox_beta,& & newq_r USE lr_variables, ONLY : lr_verbosity USE io_global, ONLY : stdout USE dfunct, ONLY : newq USE control_flags, ONLY : tqr USE mp, ONLY : mp_sum, mp_barrier USE mp_global, ONLY : intra_bgrp_comm use lr_exx_kernel #ifdef __ENVIRON USE plugin_flags, ONLY : use_environ USE scf, ONLY : rho USE solvent_tddfpt, ONLY : calc_vsolvent_tddfpt #endif ! ! IMPLICIT NONE ! COMPLEX(kind=dp),INTENT(in) :: evc1(npwx,nbnd,nks) COMPLEX(kind=dp),INTENT(out) :: evc1_new(npwx,nbnd,nks),& & sevc1_new(npwx,nbnd,nks) ! output : sevc1_new = S * evc1_new ! LOGICAL, INTENT(in) :: interaction ! ! Local variables ! INTEGER :: ir, ibnd, ik, ig, ia, mbia INTEGER :: ijkb0, na, nt, ih, jh, ikb, jkb, iqs,jqs ! REAL(kind=dp), ALLOCATABLE :: dvrs(:,:), dvrss(:) REAL(kind=dp), ALLOCATABLE :: d_deeq(:,:,:,:) ! ! Environ related arrays ! REAL(kind=dp), ALLOCATABLE :: & dv_pol(:), & ! response polarization potential dv_epsilon(:) ! response dielectric potential ! COMPLEX(kind=dp), ALLOCATABLE :: dvrs_temp(:,:) COMPLEX(kind=dp), ALLOCATABLE :: spsi1(:,:) COMPLEX(kind=dp), ALLOCATABLE :: dvrsc(:,:), dvrssc(:) ! COMPLEX(kind=dp) :: fp, fm ! REAL(kind=dp), ALLOCATABLE, DIMENSION(:) :: w1, w2 ! ! IF (lr_verbosity > 5) THEN WRITE(stdout,'("")') ENDIF ! CALL start_clock('lr_apply') ! IF (interaction) CALL start_clock('lr_apply_int') IF (.not.interaction) CALL start_clock('lr_apply_no') ! ALLOCATE( d_deeq(nhm, nhm, nat, nspin) ) d_deeq(:,:,:,:)=0.0d0 ! ALLOCATE( spsi1(npwx, nbnd) ) spsi1(:,:)=(0.0d0,0.0d0) ! IF( interaction ) THEN ! ! Calculate the full L ! IF(gamma_only) THEN ALLOCATE( dvrs(dfftp%nnr, nspin) ) ALLOCATE( dvrss(dffts%nnr) ) dvrs(:,:)=0.0d0 dvrss(:)=0.0d0 ELSE ALLOCATE( dvrsc(dfftp%nnr, nspin) ) ALLOCATE( dvrssc(dffts%nnr) ) dvrsc(:,:)=0.0d0 dvrssc(:) =0.0d0 ENDIF ! ! Calculation of the charge density response ! CALL lr_calc_dens( evc1, .false. ) ! ! Given the change of the charge density ! we calculate the change of the Hartree and XC potential and ! put it in dvrss() ! IF (no_hxc) THEN ! ! With no_hxc=.true. we recover the independent electrion ! approximation, so we zero the interation. ! IF(gamma_only) THEN dvrs(:,1)=0.0d0 CALL interpolate (dvrs(:,1),dvrss,-1) ELSE dvrsc(:,1)=0.0d0 CALL cinterpolate (dvrsc(:,1),dvrssc,-1) ENDIF ! ELSE ! IF(gamma_only) THEN dvrs(:,1)=rho_1(:,1) ! ! In the gamma_only case dvrs is real, but dv_of_drho expects ! a complex array on input, hence this temporary variable. ! ALLOCATE( dvrs_temp(dfftp%nnr, nspin) ) dvrs_temp = CMPLX( dvrs, 0.0d0, kind=dp ) ! DEALLOCATE ( dvrs ) ! CALL dv_of_drho(0,dvrs_temp,.FALSE.) ! ALLOCATE ( dvrs(dfftp%nnr, nspin) ) dvrs=DBLE(dvrs_temp) DEALLOCATE(dvrs_temp) ! #ifdef __ENVIRON ! IF ( use_environ ) THEN ! ALLOCATE( dv_pol(dfftp%nnr) ) ALLOCATE( dv_epsilon(dfftp%nnr) ) dv_pol(:) = 0.0d0 dv_epsilon(:) = 0.0d0 ! WRITE( stdout, '(5x,"ENVIRON: Calculate the response & & polarization and dielectric potentials")' ) ! CALL calc_vsolvent_tddfpt(dfftp%nnr, nspin, rho%of_r(:,1), & & rho_1(:,1), dv_pol, dv_epsilon) ! ! Add the response polarization and dielectric potentials ! to the response HXC potential. ! dvrs(:,1) = dvrs(:,1) + dv_pol(:) + dv_epsilon(:) ! DEALLOCATE( dv_pol ) DEALLOCATE( dv_epsilon ) ! ENDIF #endif ! ELSE dvrsc(:,1)=rho_1c(:,1) ! CALL dv_of_drho(0,dvrsc,.FALSE.) ! ENDIF IF ( okvan ) THEN IF ( tqr ) THEN CALL newq_r(dvrs,d_deeq,.TRUE.) ELSE ALLOCATE( psic(dfftp%nnr) ) psic(:)=(0.0d0,0.0d0) ! CALL newq(dvrs,d_deeq,.TRUE.) ! DEALLOCATE( psic ) ENDIF ENDIF CALL add_paw_to_deeq(d_deeq) ! ! Put the nteraction on the smooth grid. ! IF (gamma_only) THEN CALL interpolate (dvrs(:,1),dvrss,-1) ELSE CALL cinterpolate (dvrsc(:,1),dvrssc,-1) ENDIF ENDIF ! ENDIF ! ! Make sure the psic workspace is availible ! ALLOCATE ( psic (dffts%nnr) ) ! IF( gamma_only ) THEN ! CALL lr_apply_liouvillian_gamma() ! ELSE ! CALL lr_apply_liouvillian_k() ! ENDIF ! DEALLOCATE ( psic ) ! IF ( (interaction .or. lr_exx) .and. (.not.ltammd) ) THEN ! ! Normal interaction ! if(.not. davidson) WRITE(stdout,'(5X,"lr_apply_liouvillian: & &applying interaction: normal")') ! ! Here we add the two terms: ! [H(k) - E(k)] * evc1(k) + P_c(k) [dV_{HXC} * revc0(k)] ! CALL zaxpy(size_evc,CMPLX(1.0d0,0.0d0,kind=dp),& &evc1_new(:,:,:), 1, sevc1_new(:,:,:), 1) ! ! ELSEIF ( interaction .and. ltammd ) THEN ! ! Tamm-dancoff interaction ! if(.not. davidson) WRITE(stdout,'(5X,"lr_apply_liouvillian:& & applying interaction: tamm-dancoff")') ! ! Here evc1_new contains the interaction ! CALL zaxpy(size_evc,CMPLX(0.5d0,0.0d0,kind=dp),& &evc1_new(:,:,:) , 1 , sevc1_new(:,:,:),1) ! ! ELSE ! ! Non interacting ! if(.not. davidson) WRITE(stdout,'(5X,"lr_apply_liouvillian:& & not applying interaction")') ! ENDIF ! IF (gstart == 2 .AND. gamma_only ) sevc1_new(1,:,:) = & &CMPLX( REAL( sevc1_new(1,:,:), dp ), 0.0d0 ,dp ) ! IF(gstart==2 .and. gamma_only) THEN ! DO ik=1,nks ! DO ibnd=1,nbnd ! ! IF (abs(aimag(sevc1_new(1,ibnd,ik)))>1.0d-12) THEN ! CALL errore(' lr_apply_liouvillian ',& 'Imaginary part of G=0 '// & 'component does not equal zero',1) ! ENDIF ! ENDDO ! ENDDO ! ENDIF ! ! Here we apply the S^{-1} operator. ! See equations after Eq.(47) of B. Walker et al., J. Chem. Phys. ! 127, 164106 (2007). ! ! S^{-1} ( H(k)*evc1(k) - E(k) * S evc1(k) ) ! or ! S^{-1} ( H(k)*evc1(k) - E(k) * S evc1(k) + P_c(k) [dV_{HXC} * ! revc0(k)] ) ! DO ik=1,nks ! CALL sm1_psi(.FALSE., ik, npwx, npw_k(ik), nbnd, & &sevc1_new(1,1,ik), evc1_new(1,1,ik)) ! ENDDO ! IF (allocated(dvrs)) DEALLOCATE(dvrs) IF (allocated(dvrss)) DEALLOCATE(dvrss) DEALLOCATE(d_deeq) DEALLOCATE(spsi1) ! ! IF (interaction) CALL stop_clock('lr_apply_int') IF (.not.interaction) CALL stop_clock('lr_apply_no') ! CALL stop_clock('lr_apply') ! RETURN ! CONTAINS ! SUBROUTINE lr_apply_liouvillian_gamma() ! USE lr_variables, ONLY : becp1, tg_revc0 USE wavefunctions_module, ONLY : psic USE realus, ONLY : tg_psic USE mp_global, ONLY : me_bgrp USE fft_base, ONLY : dffts, tg_gather USE mp_global, ONLY : ibnd_start, ibnd_end, inter_bgrp_comm USE mp, ONLY : mp_sum USE lr_exx_kernel, ONLY : lr_exx_sum_int ! REAL(kind=dp), ALLOCATABLE :: becp2(:,:) REAL(kind=dp), ALLOCATABLE :: tg_dvrss(:) LOGICAL :: use_tg INTEGER :: v_siz, incr, ioff INTEGER :: ibnd_start_gamma, ibnd_end_gamma ! use_tg=dffts%have_task_groups incr = 2 ! IF ( nkb > 0 .and. okvan ) THEN ! ALLOCATE(becp2(nkb,nbnd)) becp2(:,:)=0.0d0 ! ENDIF ! ! Now apply to the ground state wavefunctions ! and convert to real space ! IF ( interaction ) THEN ! CALL start_clock('interaction') IF (nkb > 0 .and. okvan) THEN ! calculation of becp2 becp2(:,:) = 0.0d0 ! ijkb0 = 0 ! DO nt = 1, ntyp ! DO na = 1, nat ! IF ( ityp(na) == nt ) THEN ! DO ibnd = 1, nbnd ! DO jh = 1, nh(nt) ! jkb = ijkb0 + jh ! DO ih = 1, nh(nt) ! ikb = ijkb0 + ih becp2(ikb, ibnd) = becp2(ikb, ibnd) + & d_deeq(ih,jh,na,1) * becp1(jkb,ibnd) ! ENDDO ! ENDDO ! ENDDO ! ijkb0 = ijkb0 + nh(nt) ! ENDIF ! ENDDO ! ENDDO !end: calculation of becp2 ENDIF IF( dffts%have_task_groups ) THEN ! v_siz = dffts%tg_nnr * dffts%nogrp ! incr = 2 * dffts%nogrp ! ALLOCATE( tg_dvrss(1:v_siz) ) tg_dvrss=0.0d0 ! CALL tg_gather(dffts, dvrss, tg_dvrss) ! ENDIF ! ! evc1_new is used as a container for the interaction ! evc1_new(:,:,:)=(0.0d0,0.0d0) ! ibnd_start_gamma=ibnd_start IF (MOD(ibnd_start, 2)==0) ibnd_start_gamma = ibnd_start+1 ibnd_end_gamma = MAX(ibnd_end, ibnd_start_gamma) ! IF (lr_exx) CALL lr_exx_sum_int() ! DO ibnd=ibnd_start_gamma,ibnd_end_gamma,incr ! DO ibnd=1,nbnd,2 ! ! Product with the potential vrs = (vltot+vr) ! revc0 is on smooth grid. psic is used up to smooth grid ! IF(dffts%have_task_groups) THEN ! DO ir=1, dffts%nr1x*dffts%nr2x*dffts%tg_npp( me_bgrp + 1 ) ! tg_psic(ir)=tg_revc0(ir,ibnd,1)*CMPLX(tg_dvrss(ir),0.0d0,dp) ! ENDDO ! ELSE ! DO ir=1,dffts%nnr ! psic(ir)=revc0(ir,ibnd,1)*CMPLX(dvrss(ir),0.0d0,dp) ! ENDDO ! ENDIF ! IF (lr_exx) THEN CALL lr_exx_apply_revc_int(psic, ibnd, nbnd,1) ENDIF ! IF (real_space_debug > 7 .and. okvan .and. nkb > 0) THEN !THE REAL SPACE PART (modified from s_psi) !fac = sqrt(omega) ! ijkb0 = 0 iqs = 0 jqs = 0 ! DO nt = 1, ntyp ! DO ia = 1, nat ! IF ( ityp(ia) == nt ) THEN ! mbia = maxbox_beta(ia) ALLOCATE( w1(nh(nt)), w2(nh(nt)) ) w1 = 0.D0 w2 = 0.D0 ! DO ih = 1, nh(nt) ! DO jh = 1, nh(nt) ! jkb = ijkb0 + jh w1(ih) = w1(ih) + becp2(jkb, ibnd) IF ( ibnd+1 <= nbnd ) w2(ih) = w2(ih) + & &becp2(jkb, ibnd+1) ! ENDDO ! ENDDO ! !w1 = w1 * fac !w2 = w2 * fac ijkb0 = ijkb0 + nh(nt) ! DO ih = 1, nh(nt) ! DO ir = 1, mbia ! iqs = jqs + ir psic( box_beta(ir,ia) ) = & &psic( box_beta(ir,ia) ) + & &betasave(ia,ih,ir)*& &CMPLX( w1(ih), w2(ih) ) ! ENDDO ! jqs = iqs ! ENDDO ! DEALLOCATE( w1, w2 ) ! ENDIF ! ENDDO ! ENDDO ENDIF ! ! Back to reciprocal space ! CALL bfft_orbital_gamma (evc1_new(:,:,1), ibnd, nbnd,.false.) ! ENDDO ! #ifdef __MPI CALL mp_sum( evc1_new(:,:,1), inter_bgrp_comm ) #endif IF(dffts%have_task_groups) DEALLOCATE (tg_dvrss) ! ! IF( nkb > 0 .and. okvan .and. real_space_debug <= 7) THEN !The non real_space part CALL dgemm( 'N', 'N', 2*npw_k(1), nbnd, nkb, 1.d0, vkb, & 2*npwx, becp2, nkb, 1.d0, evc1_new, 2*npwx ) ! ENDIF ! CALL stop_clock('interaction') ! ENDIF ! IF (lr_exx .AND. .NOT.interaction) CALL lr_exx_kernel_noint(evc1,evc1_new) ! ! Call h_psi on evc1 such that h.evc1 = sevc1_new ! CALL h_psi(npwx,npw_k(1),nbnd,evc1(1,1,1),sevc1_new(1,1,1)) ! ! spsi1 = s*evc1 ! IF (real_space_debug > 9 ) THEN DO ibnd=1,nbnd,2 CALL fft_orbital_gamma(evc1(:,:,1),ibnd,nbnd) CALL s_psir_gamma(ibnd,nbnd) CALL bfft_orbital_gamma(spsi1,ibnd,nbnd) ENDDO ELSE CALL s_psi(npwx,npw_k(1),nbnd,evc1(1,1,1),spsi1) ENDIF ! ! Subtract the eigenvalues ! DO ibnd=1,nbnd ! CALL zaxpy(npw_k(1), CMPLX(-(et(ibnd,1)-scissor), & &0.0d0,dp), spsi1(:,ibnd), 1, sevc1_new(:,ibnd,1), 1) ! ENDDO ! IF( nkb > 0 .and. okvan ) DEALLOCATE(becp2) ! RETURN ! END SUBROUTINE lr_apply_liouvillian_gamma ! SUBROUTINE lr_apply_liouvillian_k() ! USE lr_variables, ONLY : becp1_c USE wvfct, ONLY : current_k, npw ! COMPLEX(kind=dp), ALLOCATABLE :: becp2(:,:) ! IF( nkb > 0 .AND. okvan ) THEN ! ALLOCATE(becp2(nkb,nbnd)) becp2(:,:)=(0.0d0,0.0d0) ! ENDIF ! ! Now apply to the ground state wavefunctions ! and convert to real space ! IF ( interaction ) THEN ! CALL start_clock('interaction') ! ! evc1_new is used as a container for the interaction ! evc1_new(:,:,:)=(0.0d0,0.0d0) ! DO ik=1,nks ! DO ibnd=1,nbnd ! ! Product with the potential vrs = (vltot+vr) ! DO ir=1,dffts%nnr ! psic(ir)=revc0(ir,ibnd,ik)*dvrssc(ir) ! ENDDO ! IF (lr_exx) psic(:) = psic(:) + 0.5d0 * revc_int_c(:,ibnd,ik) IF (lr_exx) THEN CALL lr_exx_apply_revc_int(psic, ibnd, nbnd, ik) ENDIF ! ! Back to reciprocal space ! CALL fwfft ('Wave', psic, dffts) ! DO ig=1,npw_k(ik) ! evc1_new(ig,ibnd,ik)=psic(nls(igk_k(ig,ik))) ! ENDDO ! ENDDO ! ENDDO ! CALL stop_clock('interaction') ! IF ( nkb > 0 .and. okvan ) THEN ! DO ik=1,nks ! CALL init_us_2(npw_k(ik),igk_k(1,ik),xk(1,ik),vkb) ! becp2(:,:) = 0.0d0 ! ijkb0 = 0 ! DO nt = 1, ntyp ! DO na = 1, nat ! IF ( ityp(na) == nt ) THEN ! DO ibnd = 1, nbnd ! DO jh = 1, nh(nt) ! jkb = ijkb0 + jh ! DO ih = 1, nh(nt) ! ikb = ijkb0 + ih becp2(ikb, ibnd) = becp2(ikb, ibnd) + & d_deeq(ih,jh,na,1) * becp1_c(jkb,ibnd,ik) ! ENDDO ! ENDDO ! ENDDO ! ijkb0 = ijkb0 + nh(nt) ! ENDIF ! ENDDO ! ENDDO ! !evc1_new(ik) = evc1_new(ik) + vkb*becp2(ik) CALL zgemm( 'N', 'N', npw_k(ik), nbnd, nkb, (1.d0,0.d0), vkb, & npwx, becp2, nkb, (1.d0,0.d0), evc1_new(:,:,ik), npwx ) ! ENDDO ! ENDIF ! ENDIF ! ! Call h_psi on evc1 ! h_psi uses arrays igk and npw, so restore those ! IF (lr_exx .AND. .NOT.interaction) CALL lr_exx_kernel_noint(evc1,evc1_new) DO ik=1,nks ! CALL init_us_2(npw_k(ik),igk_k(1,ik),xk(1,ik),vkb) ! DO ig=1,npw_k(ik) ! g2kin(ig)=((xk(1,ik)+g(1,igk_k(ig,ik)))**2 & +(xk(2,ik)+g(2,igk_k(ig,ik)))**2 & +(xk(3,ik)+g(3,igk_k(ig,ik)))**2)*tpiba2 ! ENDDO ! igk(:)=igk_k(:,ik) current_k = ik npw=npw_k(ik) ! CALL h_psi(npwx,npw_k(ik),nbnd,evc1(1,1,ik),sevc1_new(1,1,ik)) ! CALL s_psi(npwx,npw_k(ik),nbnd,evc1(1,1,ik),spsi1) ! ! Subtract the eigenvalues ! DO ibnd=1,nbnd ! DO ig=1,npw_k(ik) ! sevc1_new(ig,ibnd,ik)=sevc1_new(ig,ibnd,ik) & -cmplx(et(ibnd,ik),0.0d0,dp)*spsi1(ig,ibnd) ! ENDDO ! ENDDO ! ENDDO ! end k loop ! IF( nkb > 0 .and. okvan ) DEALLOCATE(becp2) ! RETURN END SUBROUTINE lr_apply_liouvillian_k ! END SUBROUTINE lr_apply_liouvillian !----------------------------------------------------------------------- TDDFPT/src/lr_alloc_init.f900000755000175000017500000001337712341371472014066 0ustar mbamba!----------------------------------------------------------------------- SUBROUTINE lr_alloc_init() !--------------------------------------------------------------------- ! ... allocates and initialises linear response variables !--------------------------------------------------------------------- ! Modified by Osman Baris Malcioglu in 2009 ! USE fft_base, ONLY : dfftp USE fft_base, ONLY : dffts USE klist, ONLY : nks USE lr_variables USE uspp, ONLY : nkb USE lsda_mod, ONLY : nspin USE wvfct, ONLY : npwx, nbnd USE control_flags, ONLY : gamma_only USE io_global, ONLY : stdout USE charg_resp, ONLY : w_T, w_T_beta_store, w_T_gamma_store, & & w_T_zeta_store, w_T_npol,chi USE realus, ONLY : igk_k, npw_k, tg_psic USE control_ph, ONLY : nbnd_occ USE noncollin_module, ONLY : nspin_mag USE eqv, ONLY : dmuxc USE wavefunctions_module, ONLY : evc USE kinds, ONLY : dp USE control_ph, ONLY : nbnd_occ ! IMPLICIT NONE ! IF (lr_verbosity > 5) THEN WRITE(stdout,'("")') ENDIF ! IF (nbnd>nbnd_occ(1)) THEN if(.not. davidson) WRITE(stdout,'(/,5X,"Warning: There are virtual& states in the input file, trying to disregard in response calculation")') nbnd_total=nbnd nbnd=nbnd_occ(1) ELSE if(davidson) WRITE(stdout,'(/5X,"(XC.G): No virtrual state!! For analysis the property of transitions, & & it is suggested to calculate some virtual states. ")') nbnd_total=nbnd ENDIF IF (lr_verbosity > 7) THEN WRITE(stdout,'("NPWX=",I15)') npwx WRITE(stdout,'("NBND=",I15)') nbnd WRITE(stdout,'("NKS=",I15)') nks WRITE(stdout,'("NRXX=",I15)') dfftp%nnr WRITE(stdout,'("NSPIN_MAG=",I15)') nspin_mag ENDIF IF (allocated(evc)) THEN DEALLOCATE(evc) ALLOCATE(evc(npwx,nbnd)) ENDIF ALLOCATE(evc0(npwx,nbnd,nks)) ALLOCATE(sevc0(npwx,nbnd,nks)) IF (project .or. davidson) THEN WRITE(stdout,'(5x,"Allocating ",I5," extra bands for projection")') nbnd_total-nbnd ALLOCATE(F(nbnd,(nbnd_total-nbnd),n_ipol)) ALLOCATE(R(nbnd,(nbnd_total-nbnd),n_ipol)) ALLOCATE(chi(3,3)) chi(:,:)=cmplx(0.0d0,0.0d0,dp) F(:,:,:)=cmplx(0.0d0,0.0d0,dp) R(:,:,:)=cmplx(0.0d0,0.0d0,dp) ENDIF ! ALLOCATE(evc1_old(npwx,nbnd,nks,2)) ALLOCATE(evc1(npwx,nbnd,nks,2)) ALLOCATE(evc1_new(npwx,nbnd,nks,2)) !if(pseudo_hermitian) then ALLOCATE(sevc1_new(npwx,nbnd,nks,2)) sevc1_new(:,:,:,:)=(0.0d0,0.0d0) !else ALLOCATE(sevc1(npwx,nbnd,nks,2)) sevc1(:,:,:,:)=(0.0d0,0.0d0) !endif ALLOCATE(d0psi(npwx,nbnd,nks,n_ipol)) ! IF(dffts%have_task_groups) THEN ALLOCATE(tg_revc0(dffts%tg_nnr * dffts%nogrp,nbnd,nks)) IF(.NOT. ALLOCATED(tg_psic)) & & ALLOCATE( tg_psic(dffts%tg_nnr * dffts%nogrp) ) ELSE ALLOCATE(revc0(dffts%nnr,nbnd,nks)) ENDIF ! IF(gamma_only) THEN ALLOCATE(rho_1(dfftp%nnr,nspin_mag)) rho_1(:,:)=0.0d0 ELSE ALLOCATE(rho_1c(dfftp%nnr,nspin_mag)) rho_1c(:,:)=(0.0d0,0.0d0) ENDIF !allocate(rho_tot(dfftp%nnr)) IF (charge_response == 1 ) THEN !allocate(rho_1_tot(dfftp%nnr,nspin_mag)) !Due to broadening this is now done in lr_charg_resp !rho_1_tot(:,:)=0.0d0 !print *,"allocating beta w_t" ALLOCATE(w_T_beta_store(itermax_int)) ALLOCATE(w_T_gamma_store(itermax_int)) ALLOCATE(w_T_zeta_store(w_T_npol,itermax_int)) ALLOCATE(w_T(itermax_int)) w_T_gamma_store(:)=0.0d0 w_T_beta_store(:)=0.0d0 w_T_zeta_store(:,:)=cmplx(0.0d0,0.0d0,dp) ENDIF !if (charge_response /=0) then ! allocate(w_T(itermax_int)) !endif ALLOCATE(dmuxc ( dfftp%nnr , nspin , nspin)) !print *, "dmuxc ALLOCATED",allocated(dmuxc)," SIZE=",size(dmuxc) !print *, "nks=",nks !allocate (nbnd_occ (nks)) ! evc0(:,:,:)=(0.0d0,0.0d0) evc1_old(:,:,:,:)=(0.0d0,0.0d0) evc1(:,:,:,:)=(0.0d0,0.0d0) evc1_new(:,:,:,:)=(0.0d0,0.0d0) !rho_tot(:)=0.0d0 d0psi(:,:,:,:)=(0.0d0,0.0d0) ! ALLOCATE(alpha_store(n_ipol,itermax)) ALLOCATE(beta_store(n_ipol,itermax)) ALLOCATE(gamma_store(n_ipol,itermax)) ALLOCATE(zeta_store(n_ipol,n_ipol,itermax)) alpha_store(:,:)=0.0d0 beta_store(:,:)=0.0d0 gamma_store(:,:)=0.0d0 zeta_store(:,:,:)=(0.0d0,0.0d0) ! IF(gamma_only) THEN CALL lr_alloc_init_gamma() ELSE CALL lr_alloc_init_k() ENDIF ! RETURN ! CONTAINS ! SUBROUTINE lr_alloc_init_gamma() ! USE becmod, ONLY : allocate_bec_type, bec_type, becp ! IF (nkb > 0) THEN #ifdef __STD_F95 IF (.not. associated(becp%r)) CALL allocate_bec_type(nkb,nbnd,becp) #else IF (.not. allocated(becp%r)) CALL allocate_bec_type(nkb,nbnd,becp) #endif becp%r(:,:)=0.0d0 ALLOCATE(becp1(nkb,nbnd)) becp1(:,:)=0.0d0 IF (project .or. davidson) THEN ALLOCATE(becp1_virt(nkb,nbnd_total-nbnd)) becp1_virt(:,:)=0.0d0 ENDIF ENDIF ! RETURN END SUBROUTINE lr_alloc_init_gamma ! SUBROUTINE lr_alloc_init_k() USE becmod, ONLY : allocate_bec_type, bec_type, becp ! IF (nkb > 0) THEN #ifdef __STD_F95 IF(.not. associated(becp%k)) CALL allocate_bec_type(nkb,nbnd,becp) #else IF(.not. allocated(becp%k)) CALL allocate_bec_type(nkb,nbnd,becp) #endif becp%k(:,:)=(0.0d0,0.0d0) ALLOCATE(becp1_c(nkb,nbnd,nks)) becp1_c(:,:,:)=(0.0d0,0.0d0) IF (project .or. davidson) THEN ALLOCATE(becp1_c_virt(nkb,nbnd_total-nbnd,nks)) becp1_c_virt(:,:,:)=(0.0d0,0.0d0) ENDIF ENDIF ! RETURN END SUBROUTINE lr_alloc_init_k ! END SUBROUTINE lr_alloc_init !---------------------------------------------------------------------------- TDDFPT/src/Makefile0000644000175000017500000000405712341371472012364 0ustar mbamba# Makefile for PW #Modified for v4.0 by obm include ../../make.sys IFLAGS = -I../../include LIBOBJS = ../../flib/ptools.a ../../flib/flib.a ../../clib/clib.a ../../iotk/src/libiotk.a # location of needed modules MODFLAGS= $(MOD_FLAG)../../iotk/src $(MOD_FLAG)../../Modules \ $(MOD_FLAG) . $(MOD_FLAG)../../PW/src \ $(MOD_FLAG)../../PHonon/PH QEMODS = ../../Modules/libqemod.a PWOBJS = ../../PW/src/libpw.a PHOBJS=../../PHonon/PH/libph.a LROBJS= \ lr_variables.o \ lr_charg_resp.o \ bcast_lr_input.o \ lr_readin.o \ lr_alloc_init.o \ lr_calc_dens.o \ lr_dot.o \ lr_dealloc.o \ lr_ortho.o \ lr_read_wf.o \ lr_normalise.o \ lr_lanczos.o \ lr_apply_liouvillian.o \ lr_dv_setup.o \ lr_solve_e.o \ lr_dvpsi_e.o \ lr_sm1_psi.o \ stop_lr.o \ lr_read_d0psi.o \ lr_restart.o \ lr_write_restart.o \ print_clock_lr.o \ sd0psi.o \ lr_set_boxes_density.o \ lr_init_nfo.o \ lr_exx_kernel.o \ lr_dav_variables.o\ lr_dav_routines.o\ lr_us.o\ lr_dav_debug.o TLDEPS=bindir libs pw ph all : tldeps libtddfpt.a turbo_lanczos.x turbo_davidson.x libtddfpt.a : $(LROBJS) $(AR) $(ARFLAGS) $@ $? $(RANLIB) $@ turbo_lanczos.x : lr_main.o libtddfpt.a $(PHOBJS) $(PWOBJS) $(QEMODS) $(LIBOBJS) $(LD) $(LDFLAGS) -o $@ \ lr_main.o libtddfpt.a $(PHOBJS) $(PWOBJS) $(QEMODS) $(LIBOBJS) $(LIBS) - ( cd ../../bin ; ln -fs ../TDDFPT/src/$@ . ) - if [ -d ../bin ] ; then ( cd ../bin ; ln -fs ../src/$@ . ); fi turbo_davidson.x : lr_dav_main.o libtddfpt.a $(PHOBJS) $(PWOBJS) $(QEMODS) $(LIBOBJS) $(LD) $(LDFLAGS) -o $@ \ lr_dav_main.o libtddfpt.a $(PHOBJS) $(PWOBJS) $(QEMODS) $(LIBOBJS) $(LIBS) - ( cd ../../bin ; ln -fs ../TDDFPT/src/$@ . ) - if [ -d ../bin ] ; then ( cd ../bin ; ln -fs ../src/$@ . ); fi dene.x : obm_tests.o $(MPIF90) $(LDFLAGS) -o dene.x \ $(PWOBJS) $(PHOBJS) obm_tests.o $(QEMODS) $(LIBOBJS) $(LIBS) tldeps : if test -n "$(TLDEPS)" ; then \ ( cd ../.. ; $(MAKE) $(TLDEPS) || exit 1 ) ; fi clean : - /bin/rm -f ../bin/turbo_lanczos.x ../bin/turbo_davidson.x *.x *.o *~ *.d *.mod *.i work.pc *.a include make.depend # DO NOT DELETE TDDFPT/src/lr_dvpsi_e.f900000755000175000017500000001627312341371472013400 0ustar mbamba!! ! Copyright (C) 2001-2008 Quantum ESPRESSO group ! This file is distributed under the terms of the ! GNU General Public License. See the file `License' ! in the root directory of the present distribution, ! or http://www.gnu.org/copyleft/gpl.txt . ! !---------------------------------------------------------------------- ! ! Modified by Osman Baris Malcioglu (2009) ! Rebased wrt PHONON routines. S J Binnie (2011) SUBROUTINE lr_dvpsi_e(ik,ipol,dvpsi) !---------------------------------------------------------------------- ! ! On output: dvpsi contains P_c^+ x | psi_ik > in crystal axis ! (projected on at(*,ipol) ) ! ! dvpsi is COMPUTED and WRITTEN on file (vkb,evc,igk must be set) ! OBM: ^ This is now handled elesewhere ! USE kinds, ONLY : DP USE cell_base, ONLY : tpiba, at USE ions_base, ONLY : ntyp => nsp USE io_global, ONLY : stdout USE klist, ONLY : xk USE wvfct, ONLY : npw, npwx, nbnd, igk, g2kin, et USE wavefunctions_module, ONLY : evc USE noncollin_module, ONLY : noncolin, npol USE becmod, ONLY : allocate_bec_type, calbec, becp,& & deallocate_bec_type, bec_type USE uspp, ONLY : okvan, nkb, vkb USE uspp_param, ONLY : nh, nhm USE phus, ONLY : dpqq USE control_flags, ONLY : gamma_only USE control_ph, ONLY : nbnd_occ USE realus, ONLY : npw_k USE lr_variables, ONLY : lr_verbosity USE io_global, ONLY : stdout USE qpoint, ONLY : igkq ! ! IMPLICIT NONE ! INTEGER, INTENT(in) :: ipol, ik ! COMPLEX(kind=dp),INTENT(out) :: dvpsi(npwx,nbnd) ! ! Local variables ! INTEGER :: ig, ibnd, lter ! counters REAL(kind=dp) :: atnorm COMPLEX(kind=dp),ALLOCATABLE :: d0psi(:,:) ! REAL(DP), ALLOCATABLE :: h_diag (:,:), eprec(:) ! diagonal part of h_scf real(DP) :: anorm ! preconditioning cut-off REAL(DP), PARAMETER :: thresh=1.0e-5_DP ! the desired convergence of linter LOGICAL :: conv_root ! true if convergence has been achieved COMPLEX(DP), ALLOCATABLE :: work (:,:), spsi(:,:) TYPE(bec_type) :: becp1 TYPE(bec_type) :: becp2 EXTERNAL ch_psi_all, cg_psi ! CALL start_clock ('lr_dvpsi_e') IF (lr_verbosity > 5) WRITE(stdout,'("")') conv_root = .TRUE. ALLOCATE(d0psi(npwx*npol,nbnd)) d0psi=(0.d0, 0.d0) dvpsi=(0.d0, 0.d0) ! ALLOCATE (h_diag( npwx*npol, nbnd)) h_diag=0.d0 CALL allocate_bec_type ( nkb, nbnd, becp1 ) CALL calbec ( npw_k(ik), vkb, evc, becp1 ) CALL allocate_bec_type ( nkb, nbnd, becp2 ) CALL commutator_Hx_psi (ik, nbnd_occ(ik), becp1, becp2, ipol, d0psi ) ! ! orthogonalize d0psi to the valence subspace: ps = ! Apply -P^+_c ! NB it uses dvpsi as workspace ! IF (okvan) CALL calbec ( npw_k(ik), vkb, evc, becp, nbnd) CALL orthogonalize(d0psi, evc, ik, ik, dvpsi,npw_k(ik)) d0psi=-d0psi ! ! d0psi contains P^+_c [H-eS,x] psi_v for the polarization direction ipol ! Now solve the linear systems (H-e_vS)*P_c(x*psi_v)=P_c^+ [H-e_vS,x]*psi_v ! ! eprec is now calculated on the fly for each k point ALLOCATE(eprec(nbnd)) CALL lr_calc_eprec(eprec) DO ibnd = 1, nbnd_occ (ik) DO ig = 1, npw_k(ik) h_diag (ig, ibnd) = 1.d0 / max (1.0d0, g2kin (ig) / eprec (ibnd) ) ENDDO IF (noncolin) THEN DO ig = 1, npw_k(ik) h_diag (ig+npwx, ibnd) = 1.d0/max(1.0d0,g2kin(ig)/eprec(ibnd)) ENDDO ENDIF ENDDO ! !OBM!!! upto here, the dvpsi was used as a scratch ! dvpsi(:,:) = (0.d0, 0.d0) ! igkq => igk ! PG: needed by h_psiq, called by ch_psi_all ! CALL cgsolve_all (ch_psi_all, cg_psi, et (1, ik), d0psi, dvpsi, & h_diag, npwx, npw_k(ik), thresh, ik, lter, conv_root, anorm, & nbnd_occ(ik), 1) ! IF (.not.conv_root) WRITE( stdout, '(5x,"ik",i4," ibnd",i4, & & " linter: root not converged ",e10.3)') & ik, ibnd, anorm ! CALL flush_unit( stdout ) ! ! ! we have now obtained P_c x |psi>. ! In the case of USPP this quantity is needed for the Born ! effective charges, so we save it to disc ! ! In the US case we obtain P_c x |psi>, but we need P_c^+ x | psi>, ! therefore we apply S again, and then subtract the additional term ! furthermore we add the term due to dipole of the augmentation charges. ! IF (okvan) THEN ! ! for effective charges ! ALLOCATE (spsi ( npwx*npol, nbnd)) CALL calbec (npw_k(ik), vkb, dvpsi, becp ) CALL s_psi(npwx,npw_k(ik),nbnd,dvpsi,spsi) CALL DCOPY(2*npwx*npol*nbnd,spsi,1,dvpsi,1) DEALLOCATE (spsi) ALLOCATE (dpqq( nhm, nhm, 3, ntyp)) CALL compute_qdipol(dpqq) CALL qdipol_cryst() CALL adddvepsi_us(becp1,becp2,ipol,ik,dvpsi) DEALLOCATE (dpqq) ENDIF ! ! orthogonalize dvpsi to the valence subspace ! IF (okvan) CALL calbec ( npw_k(ik), vkb, evc, becp, nbnd) ALLOCATE (work ( npwx, nbnd ) ) work = evc ! work will be corrupted on exit from orthogonalize CALL orthogonalize(dvpsi, evc, ik, ik, work,npw_k(ik)) dvpsi=-dvpsi DEALLOCATE(work) DEALLOCATE (h_diag) DEALLOCATE (eprec) DEALLOCATE (d0psi) !OBM!!!! Addendum to PH dvpsi IF (okvan) THEN ALLOCATE (spsi ( npwx*npol, nbnd)) CALL sm1_psi(.true.,ik,npwx,npw_k(ik),nbnd,dvpsi,spsi) dvpsi(:,:) = spsi(:,:) DEALLOCATE(spsi) ENDIF ! ! For some ibrav the crystal axes are not normalized ! Here we include the correct normalization ! for Lanczos initial wfcs atnorm=dsqrt(at(1,ipol)**2+at(2,ipol)**2+at(3,ipol)**2) ! dvpsi(:,:)=dvpsi(:,:)/atnorm ! !nrec = (ipol - 1)*nksq + ik !call davcio(dvpsi, lrebar, iuebar, nrec, 1) !this_pcxpsi_is_on_file(ik,ipol) = .true. CALL deallocate_bec_type ( becp1 ) IF (nkb > 0) CALL deallocate_bec_type ( becp2 ) CALL stop_clock ('lr_dvpsi_e') ! RETURN ! CONTAINS SUBROUTINE lr_calc_eprec(eprec) USE kinds, ONLY : DP USE gvect, ONLY : gstart USE wvfct, ONLY : npw, npwx, nbnd, g2kin USE wavefunctions_module, ONLY : evc USE realus, ONLY : npw_k USE mp, ONLY : mp_sum USE mp_global, ONLY : intra_bgrp_comm IMPLICIT NONE REAL(KIND=DP), INTENT(INOUT) :: eprec(nbnd) COMPLEX(KIND=DP), ALLOCATABLE :: work (:,:) REAL(KIND=DP), EXTERNAL :: ddot COMPLEX(KIND=DP), EXTERNAL :: zdotc ! the scalar products ALLOCATE (work(npwx,nbnd)) DO ibnd=1,nbnd ! work = 0.d0 ! DO ig=1,npw_k(ik) work(ig,1)=g2kin(ig)*evc(ig,ibnd) ENDDO ! IF (gamma_only) THEN eprec(ibnd)=2.0d0*DDOT(2*npw,evc(1,ibnd),1,work,1) ! IF(gstart==2) THEN eprec(ibnd)=eprec(ibnd)-DBLE(evc(1,ibnd))*DBLE(work(1,ibnd)) ENDIF ! eprec(ibnd)=1.35d0*eprec(ibnd) ELSE eprec(ibnd)=1.35d0*zdotc(npw_k(ik),evc(1,ibnd),1,work,1) ENDIF ! ENDDO ! #ifdef __MPI CALL mp_sum(eprec, intra_bgrp_comm) #endif DEALLOCATE(work) END SUBROUTINE lr_calc_eprec END SUBROUTINE lr_dvpsi_e TDDFPT/src/make.depend0000644000175000017500000003715312341371472013025 0ustar mbambabcast_lr_input.o : ../../Modules/control_flags.o bcast_lr_input.o : ../../Modules/io_files.o bcast_lr_input.o : ../../Modules/io_global.o bcast_lr_input.o : ../../Modules/mp.o bcast_lr_input.o : ../../Modules/mp_global.o bcast_lr_input.o : ../../Modules/mp_world.o bcast_lr_input.o : ../../Modules/plugin_flags.o bcast_lr_input.o : ../../PW/src/exx.o bcast_lr_input.o : ../../PW/src/realus.o bcast_lr_input.o : lr_charg_resp.o bcast_lr_input.o : lr_dav_variables.o bcast_lr_input.o : lr_variables.o lr_alloc_init.o : ../../Modules/becmod.o lr_alloc_init.o : ../../Modules/control_flags.o lr_alloc_init.o : ../../Modules/fft_base.o lr_alloc_init.o : ../../Modules/io_global.o lr_alloc_init.o : ../../Modules/kind.o lr_alloc_init.o : ../../Modules/noncol.o lr_alloc_init.o : ../../Modules/uspp.o lr_alloc_init.o : ../../Modules/wavefunctions.o lr_alloc_init.o : ../../PHonon/PH/phcom.o lr_alloc_init.o : ../../PW/src/pwcom.o lr_alloc_init.o : ../../PW/src/realus.o lr_alloc_init.o : lr_charg_resp.o lr_alloc_init.o : lr_variables.o lr_apply_liouvillian.o : ../../Modules/cell_base.o lr_apply_liouvillian.o : ../../Modules/control_flags.o lr_apply_liouvillian.o : ../../Modules/fft_base.o lr_apply_liouvillian.o : ../../Modules/fft_interfaces.o lr_apply_liouvillian.o : ../../Modules/io_global.o lr_apply_liouvillian.o : ../../Modules/ions_base.o lr_apply_liouvillian.o : ../../Modules/kind.o lr_apply_liouvillian.o : ../../Modules/mp.o lr_apply_liouvillian.o : ../../Modules/mp_global.o lr_apply_liouvillian.o : ../../Modules/plugin_flags.o lr_apply_liouvillian.o : ../../Modules/recvec.o lr_apply_liouvillian.o : ../../Modules/uspp.o lr_apply_liouvillian.o : ../../Modules/wavefunctions.o lr_apply_liouvillian.o : ../../PW/src/newd.o lr_apply_liouvillian.o : ../../PW/src/pwcom.o lr_apply_liouvillian.o : ../../PW/src/realus.o lr_apply_liouvillian.o : ../../PW/src/scf_mod.o lr_apply_liouvillian.o : lr_exx_kernel.o lr_apply_liouvillian.o : lr_variables.o lr_calc_dens.o : ../../Modules/becmod.o lr_calc_dens.o : ../../Modules/cell_base.o lr_calc_dens.o : ../../Modules/constants.o lr_calc_dens.o : ../../Modules/control_flags.o lr_calc_dens.o : ../../Modules/fft_base.o lr_calc_dens.o : ../../Modules/fft_interfaces.o lr_calc_dens.o : ../../Modules/io_files.o lr_calc_dens.o : ../../Modules/io_global.o lr_calc_dens.o : ../../Modules/ions_base.o lr_calc_dens.o : ../../Modules/kind.o lr_calc_dens.o : ../../Modules/mp.o lr_calc_dens.o : ../../Modules/mp_global.o lr_calc_dens.o : ../../Modules/noncol.o lr_calc_dens.o : ../../Modules/recvec.o lr_calc_dens.o : ../../Modules/uspp.o lr_calc_dens.o : ../../Modules/wavefunctions.o lr_calc_dens.o : ../../PW/src/pwcom.o lr_calc_dens.o : ../../PW/src/realus.o lr_calc_dens.o : lr_charg_resp.o lr_calc_dens.o : lr_exx_kernel.o lr_calc_dens.o : lr_variables.o lr_charg_resp.o : ../../Modules/becmod.o lr_charg_resp.o : ../../Modules/cell_base.o lr_charg_resp.o : ../../Modules/constants.o lr_charg_resp.o : ../../Modules/fft_base.o lr_charg_resp.o : ../../Modules/io_files.o lr_charg_resp.o : ../../Modules/io_global.o lr_charg_resp.o : ../../Modules/ions_base.o lr_charg_resp.o : ../../Modules/kind.o lr_charg_resp.o : ../../Modules/mp.o lr_charg_resp.o : ../../Modules/mp_global.o lr_charg_resp.o : ../../Modules/mp_world.o lr_charg_resp.o : ../../Modules/noncol.o lr_charg_resp.o : ../../Modules/recvec.o lr_charg_resp.o : ../../Modules/uspp.o lr_charg_resp.o : ../../PHonon/PH/phcom.o lr_charg_resp.o : ../../PW/src/pwcom.o lr_charg_resp.o : ../../PW/src/realus.o lr_charg_resp.o : lr_variables.o lr_dav_debug.o : ../../Modules/cell_base.o lr_dav_debug.o : ../../Modules/fft_base.o lr_dav_debug.o : ../../Modules/io_global.o lr_dav_debug.o : ../../Modules/kind.o lr_dav_debug.o : ../../Modules/mp.o lr_dav_debug.o : ../../Modules/mp_global.o lr_dav_debug.o : ../../Modules/mp_world.o lr_dav_debug.o : ../../Modules/recvec.o lr_dav_debug.o : ../../Modules/uspp.o lr_dav_debug.o : ../../Modules/wavefunctions.o lr_dav_debug.o : ../../PW/src/pwcom.o lr_dav_debug.o : ../../PW/src/realus.o lr_dav_debug.o : lr_dav_variables.o lr_dav_debug.o : lr_us.o lr_dav_debug.o : lr_variables.o lr_dav_main.o : ../../Modules/check_stop.o lr_dav_main.o : ../../Modules/control_flags.o lr_dav_main.o : ../../Modules/environment.o lr_dav_main.o : ../../Modules/funct.o lr_dav_main.o : ../../Modules/io_files.o lr_dav_main.o : ../../Modules/io_global.o lr_dav_main.o : ../../Modules/ions_base.o lr_dav_main.o : ../../Modules/kind.o lr_dav_main.o : ../../Modules/mp_global.o lr_dav_main.o : ../../Modules/uspp.o lr_dav_main.o : ../../Modules/version.o lr_dav_main.o : ../../Modules/wavefunctions.o lr_dav_main.o : ../../PW/src/pwcom.o lr_dav_main.o : lr_dav_debug.o lr_dav_main.o : lr_dav_routines.o lr_dav_main.o : lr_dav_variables.o lr_dav_main.o : lr_variables.o lr_dav_routines.o : ../../Modules/cell_base.o lr_dav_routines.o : ../../Modules/fft_base.o lr_dav_routines.o : ../../Modules/io_files.o lr_dav_routines.o : ../../Modules/io_global.o lr_dav_routines.o : ../../Modules/kind.o lr_dav_routines.o : ../../Modules/mp.o lr_dav_routines.o : ../../Modules/mp_global.o lr_dav_routines.o : ../../Modules/mp_world.o lr_dav_routines.o : ../../Modules/recvec.o lr_dav_routines.o : ../../Modules/uspp.o lr_dav_routines.o : ../../Modules/wavefunctions.o lr_dav_routines.o : ../../PW/src/g_psi_mod.o lr_dav_routines.o : ../../PW/src/pwcom.o lr_dav_routines.o : ../../PW/src/realus.o lr_dav_routines.o : lr_charg_resp.o lr_dav_routines.o : lr_dav_debug.o lr_dav_routines.o : lr_dav_variables.o lr_dav_routines.o : lr_us.o lr_dav_routines.o : lr_variables.o lr_dav_variables.o : ../../Modules/kind.o lr_dealloc.o : ../../Modules/becmod.o lr_dealloc.o : ../../Modules/control_flags.o lr_dealloc.o : ../../Modules/io_global.o lr_dealloc.o : ../../Modules/uspp.o lr_dealloc.o : ../../PHonon/PH/phcom.o lr_dealloc.o : ../../PW/src/realus.o lr_dealloc.o : lr_charg_resp.o lr_dealloc.o : lr_exx_kernel.o lr_dealloc.o : lr_variables.o lr_diagonalise.o : ../../Modules/io_global.o lr_diagonalise.o : ../../Modules/kind.o lr_diagonalise.o : lr_variables.o lr_dot.o : ../../Modules/control_flags.o lr_dot.o : ../../Modules/io_global.o lr_dot.o : ../../Modules/kind.o lr_dot.o : ../../Modules/mp.o lr_dot.o : ../../Modules/mp_global.o lr_dot.o : ../../Modules/recvec.o lr_dot.o : ../../PW/src/pwcom.o lr_dot.o : ../../PW/src/realus.o lr_dot.o : lr_variables.o lr_dv_setup.o : ../../Modules/fft_base.o lr_dv_setup.o : ../../Modules/funct.o lr_dv_setup.o : ../../Modules/io_global.o lr_dv_setup.o : ../../Modules/ions_base.o lr_dv_setup.o : ../../Modules/kind.o lr_dv_setup.o : ../../Modules/noncol.o lr_dv_setup.o : ../../Modules/recvec.o lr_dv_setup.o : ../../Modules/uspp.o lr_dv_setup.o : ../../PHonon/PH/phcom.o lr_dv_setup.o : ../../PW/src/pwcom.o lr_dv_setup.o : ../../PW/src/scf_mod.o lr_dv_setup.o : lr_variables.o lr_dvpsi_e.o : ../../Modules/becmod.o lr_dvpsi_e.o : ../../Modules/cell_base.o lr_dvpsi_e.o : ../../Modules/control_flags.o lr_dvpsi_e.o : ../../Modules/io_global.o lr_dvpsi_e.o : ../../Modules/ions_base.o lr_dvpsi_e.o : ../../Modules/kind.o lr_dvpsi_e.o : ../../Modules/mp.o lr_dvpsi_e.o : ../../Modules/mp_global.o lr_dvpsi_e.o : ../../Modules/noncol.o lr_dvpsi_e.o : ../../Modules/recvec.o lr_dvpsi_e.o : ../../Modules/uspp.o lr_dvpsi_e.o : ../../Modules/wavefunctions.o lr_dvpsi_e.o : ../../PHonon/PH/phcom.o lr_dvpsi_e.o : ../../PW/src/pwcom.o lr_dvpsi_e.o : ../../PW/src/realus.o lr_dvpsi_e.o : lr_variables.o lr_exx_kernel.o : ../../Modules/cell_base.o lr_exx_kernel.o : ../../Modules/fft_base.o lr_exx_kernel.o : ../../Modules/fft_custom.o lr_exx_kernel.o : ../../Modules/fft_interfaces.o lr_exx_kernel.o : ../../Modules/funct.o lr_exx_kernel.o : ../../Modules/io_global.o lr_exx_kernel.o : ../../Modules/kind.o lr_exx_kernel.o : ../../Modules/mp.o lr_exx_kernel.o : ../../Modules/mp_global.o lr_exx_kernel.o : ../../Modules/recvec.o lr_exx_kernel.o : ../../Modules/wavefunctions.o lr_exx_kernel.o : ../../PW/src/exx.o lr_exx_kernel.o : ../../PW/src/pwcom.o lr_exx_kernel.o : ../../PW/src/realus.o lr_exx_kernel.o : ../../PW/src/symm_base.o lr_exx_kernel.o : lr_variables.o lr_init_nfo.o : ../../Modules/cell_base.o lr_init_nfo.o : ../../Modules/constants.o lr_init_nfo.o : ../../Modules/io_files.o lr_init_nfo.o : ../../Modules/io_global.o lr_init_nfo.o : ../../Modules/kind.o lr_init_nfo.o : ../../Modules/mp.o lr_init_nfo.o : ../../Modules/mp_global.o lr_init_nfo.o : ../../Modules/noncol.o lr_init_nfo.o : ../../Modules/recvec.o lr_init_nfo.o : ../../PHonon/PH/phcom.o lr_init_nfo.o : ../../PW/src/pwcom.o lr_init_nfo.o : ../../PW/src/realus.o lr_init_nfo.o : lr_variables.o lr_lanczos.o : ../../Modules/becmod.o lr_lanczos.o : ../../Modules/control_flags.o lr_lanczos.o : ../../Modules/io_global.o lr_lanczos.o : ../../Modules/kind.o lr_lanczos.o : ../../Modules/uspp.o lr_lanczos.o : ../../PW/src/pwcom.o lr_lanczos.o : ../../PW/src/realus.o lr_lanczos.o : lr_charg_resp.o lr_lanczos.o : lr_us.o lr_lanczos.o : lr_variables.o lr_main.o : ../../Modules/check_stop.o lr_main.o : ../../Modules/control_flags.o lr_main.o : ../../Modules/environment.o lr_main.o : ../../Modules/fft_base.o lr_main.o : ../../Modules/funct.o lr_main.o : ../../Modules/io_files.o lr_main.o : ../../Modules/io_global.o lr_main.o : ../../Modules/ions_base.o lr_main.o : ../../Modules/kind.o lr_main.o : ../../Modules/mp.o lr_main.o : ../../Modules/mp_global.o lr_main.o : ../../Modules/mp_world.o lr_main.o : ../../Modules/plugin_flags.o lr_main.o : ../../Modules/uspp.o lr_main.o : ../../Modules/version.o lr_main.o : ../../Modules/wavefunctions.o lr_main.o : ../../PW/src/pwcom.o lr_main.o : lr_charg_resp.o lr_main.o : lr_lanczos.o lr_main.o : lr_variables.o lr_normalise.o : ../../Modules/becmod.o lr_normalise.o : ../../Modules/cell_base.o lr_normalise.o : ../../Modules/control_flags.o lr_normalise.o : ../../Modules/io_global.o lr_normalise.o : ../../Modules/kind.o lr_normalise.o : ../../Modules/recvec.o lr_normalise.o : ../../Modules/uspp.o lr_normalise.o : ../../PW/src/pwcom.o lr_normalise.o : ../../PW/src/realus.o lr_normalise.o : lr_variables.o lr_ortho.o : ../../Modules/control_flags.o lr_ortho.o : ../../Modules/io_global.o lr_ortho.o : ../../Modules/kind.o lr_ortho.o : ../../Modules/mp.o lr_ortho.o : ../../Modules/mp_global.o lr_ortho.o : ../../Modules/noncol.o lr_ortho.o : ../../Modules/recvec.o lr_ortho.o : ../../Modules/uspp.o lr_ortho.o : ../../PHonon/PH/phcom.o lr_ortho.o : ../../PW/src/pwcom.o lr_ortho.o : ../../PW/src/realus.o lr_ortho.o : lr_variables.o lr_read_d0psi.o : ../../Modules/io_files.o lr_read_d0psi.o : ../../Modules/io_global.o lr_read_d0psi.o : ../../PW/src/pwcom.o lr_read_d0psi.o : lr_variables.o lr_read_wf.o : ../../Modules/becmod.o lr_read_wf.o : ../../Modules/cell_base.o lr_read_wf.o : ../../Modules/control_flags.o lr_read_wf.o : ../../Modules/fft_base.o lr_read_wf.o : ../../Modules/fft_interfaces.o lr_read_wf.o : ../../Modules/funct.o lr_read_wf.o : ../../Modules/io_files.o lr_read_wf.o : ../../Modules/io_global.o lr_read_wf.o : ../../Modules/kind.o lr_read_wf.o : ../../Modules/mp_global.o lr_read_wf.o : ../../Modules/recvec.o lr_read_wf.o : ../../Modules/uspp.o lr_read_wf.o : ../../Modules/wavefunctions.o lr_read_wf.o : ../../PHonon/PH/phcom.o lr_read_wf.o : ../../PW/src/buffers.o lr_read_wf.o : ../../PW/src/exx.o lr_read_wf.o : ../../PW/src/pwcom.o lr_read_wf.o : ../../PW/src/realus.o lr_read_wf.o : lr_exx_kernel.o lr_read_wf.o : lr_variables.o lr_readin.o : ../../Modules/cell_base.o lr_readin.o : ../../Modules/control_flags.o lr_readin.o : ../../Modules/fft_base.o lr_readin.o : ../../Modules/funct.o lr_readin.o : ../../Modules/input_parameters.o lr_readin.o : ../../Modules/io_files.o lr_readin.o : ../../Modules/io_global.o lr_readin.o : ../../Modules/ions_base.o lr_readin.o : ../../Modules/kind.o lr_readin.o : ../../Modules/mp.o lr_readin.o : ../../Modules/mp_bands.o lr_readin.o : ../../Modules/mp_global.o lr_readin.o : ../../Modules/mp_images.o lr_readin.o : ../../Modules/mp_world.o lr_readin.o : ../../Modules/paw_variables.o lr_readin.o : ../../Modules/plugin_flags.o lr_readin.o : ../../Modules/recvec.o lr_readin.o : ../../Modules/uspp.o lr_readin.o : ../../PW/src/exx.o lr_readin.o : ../../PW/src/newd.o lr_readin.o : ../../PW/src/pwcom.o lr_readin.o : ../../PW/src/realus.o lr_readin.o : ../../PW/src/scf_mod.o lr_readin.o : ../../iotk/src/iotk_module.o lr_readin.o : lr_charg_resp.o lr_readin.o : lr_dav_variables.o lr_readin.o : lr_variables.o lr_restart.o : ../../Modules/becmod.o lr_restart.o : ../../Modules/cell_base.o lr_restart.o : ../../Modules/control_flags.o lr_restart.o : ../../Modules/fft_base.o lr_restart.o : ../../Modules/io_files.o lr_restart.o : ../../Modules/io_global.o lr_restart.o : ../../Modules/mp.o lr_restart.o : ../../Modules/mp_world.o lr_restart.o : ../../Modules/noncol.o lr_restart.o : ../../Modules/recvec.o lr_restart.o : ../../Modules/uspp.o lr_restart.o : ../../PW/src/pwcom.o lr_restart.o : ../../PW/src/realus.o lr_restart.o : lr_charg_resp.o lr_restart.o : lr_variables.o lr_set_boxes_density.o : ../../Modules/fft_base.o lr_set_boxes_density.o : ../../Modules/io_global.o lr_set_boxes_density.o : ../../Modules/kind.o lr_set_boxes_density.o : ../../Modules/mp_global.o lr_set_boxes_density.o : lr_variables.o lr_sm1_psi.o : ../../Modules/becmod.o lr_sm1_psi.o : ../../Modules/control_flags.o lr_sm1_psi.o : ../../Modules/io_global.o lr_sm1_psi.o : ../../Modules/ions_base.o lr_sm1_psi.o : ../../Modules/kind.o lr_sm1_psi.o : ../../Modules/mp.o lr_sm1_psi.o : ../../Modules/mp_global.o lr_sm1_psi.o : ../../Modules/uspp.o lr_sm1_psi.o : ../../PW/src/pwcom.o lr_sm1_psi.o : ../../PW/src/realus.o lr_sm1_psi.o : lr_variables.o lr_solve_e.o : ../../Modules/cell_base.o lr_solve_e.o : ../../Modules/control_flags.o lr_solve_e.o : ../../Modules/fft_base.o lr_solve_e.o : ../../Modules/io_files.o lr_solve_e.o : ../../Modules/io_global.o lr_solve_e.o : ../../Modules/kind.o lr_solve_e.o : ../../Modules/mp.o lr_solve_e.o : ../../Modules/mp_global.o lr_solve_e.o : ../../Modules/recvec.o lr_solve_e.o : ../../Modules/uspp.o lr_solve_e.o : ../../Modules/wavefunctions.o lr_solve_e.o : ../../PHonon/PH/phcom.o lr_solve_e.o : ../../PW/src/pwcom.o lr_solve_e.o : ../../PW/src/realus.o lr_solve_e.o : lr_variables.o lr_us.o : ../../Modules/becmod.o lr_us.o : ../../Modules/control_flags.o lr_us.o : ../../Modules/kind.o lr_us.o : ../../Modules/uspp.o lr_us.o : ../../PW/src/pwcom.o lr_us.o : ../../PW/src/realus.o lr_variables.o : ../../Modules/cell_base.o lr_variables.o : ../../Modules/control_flags.o lr_variables.o : ../../Modules/fft_base.o lr_variables.o : ../../Modules/io_global.o lr_variables.o : ../../Modules/kind.o lr_variables.o : ../../Modules/mp.o lr_variables.o : ../../Modules/mp_global.o lr_variables.o : ../../Modules/recvec.o lr_variables.o : ../../PW/src/pwcom.o lr_variables.o : ../../PW/src/realus.o lr_write_restart.o : ../../Modules/fft_base.o lr_write_restart.o : ../../Modules/io_files.o lr_write_restart.o : ../../Modules/io_global.o lr_write_restart.o : ../../Modules/noncol.o lr_write_restart.o : ../../PW/src/pwcom.o lr_write_restart.o : lr_charg_resp.o lr_write_restart.o : lr_variables.o print_clock_lr.o : ../../Modules/io_global.o print_clock_lr.o : ../../Modules/mp_world.o print_clock_lr.o : ../../Modules/plugin_flags.o print_clock_lr.o : ../../PW/src/realus.o print_clock_lr.o : lr_variables.o sd0psi.o : ../../Modules/becmod.o sd0psi.o : ../../Modules/control_flags.o sd0psi.o : ../../Modules/io_global.o sd0psi.o : ../../Modules/uspp.o sd0psi.o : ../../PW/src/pwcom.o sd0psi.o : ../../PW/src/realus.o sd0psi.o : lr_variables.o stop_lr.o : ../../Modules/cell_base.o stop_lr.o : ../../Modules/environment.o stop_lr.o : ../../Modules/io_files.o stop_lr.o : ../../Modules/io_global.o stop_lr.o : ../../Modules/ions_base.o stop_lr.o : ../../Modules/kind.o stop_lr.o : ../../Modules/mp_global.o stop_lr.o : ../../Modules/parallel_include.o stop_lr.o : ../../Modules/plugin_flags.o stop_lr.o : lr_variables.o TDDFPT/Makefile0000644000175000017500000000050612341371500011560 0ustar mbamba# Makefile for TDDFPT sinclude ../make.sys default: all all: bindir tddfpt tddfptools bindir: if [ ! -d bin ] ; then mkdir bin; fi; tddfpt: ( cd src ; $(MAKE) all || exit 1 ) tddfptools: ( cd tools ; $(MAKE) all || exit 1 ) clean : ( cd src ; $(MAKE) clean ; ) ( cd tools ; $(MAKE) clean ; ) distclean: clean TDDFPT/Doc/0000755000175000017500000000000012341371641010632 5ustar mbambaTDDFPT/Doc/INPUT_Spectrum.def0000644000175000017500000000646012341371472014103 0ustar mbambainput_description -distribution {Quantum Espresso} -package turboTDDFPT -program turbo_spectrum.x { toc {} intro { Input data format: { } = optional, [ ] = it depends. All quantities whose dimensions are not explicitly specified are in RYDBERG ATOMIC UNITS BEWARE: TABS, DOS CHARACTERS ARE POTENTIAL SOURCES OF TROUBLE Comment lines in namelists can be introduced by a "!", exactly as in fortran code. Comments lines in ``cards'' can be introduced by either a "!" or a "#" character in the first position of a line. Structure of the input data: =============================================================================== &lr_input ... / } namelist lr_input { label { This namelist is always needed ! } var prefix -type CHARACTER { default { 'pwscf' } info { Sets the prefix for generated and read files. The files generated by the ground state pw.x run should have this same prefix. } } var outdir -type CHARACTER { default { './' } info { The directory that contains the run critical files, which include the files generated by ground state pw.x run. } } var verbosity -type INTEGER { default {1} info { This integer variable controls the amount of information written to standard output. } } var itermax0 -type INTEGER { default {500} info { Number of Lanczos coefficients to be read from the file. } } var itermax -type INTEGER { default {500} info { The total number of Lanczos coefficients that will be considered in the calculation of the polarizability/absorption coefficient. If itermax > itermax0, the Lanczos coefficients in between itermax0+1 and itermax will be extrapolated. } } var extrapolation -type CHARACTER { default {'no'} info { Sets the extrapolation scheme. 'osc'= biconstant extrapolation, 'constant'=constant extrapolation and 'no'=no extrapolation. } } var epsil -type REAL { default {0.02} info { The broadening/damping term (in Rydberg units). } } var units -type INTEGER { default {0} info { The unit system used for the output and the start, end and increment input parameters. 0 = Rydbergs, 1 = Electron volts and 2 = Nanometres per electron volts. } } var start -type REAL { default {0.0} info { The polarizability and the absorption coefficient are computed starting from this value. In units set by the units variable. } } var end -type REAL { default {2.5} info { The polarizability and the absorption coefficient are computed up to this value. In units set by the units variable. } } var increment -type REAL { default {0.001} info { Incremental step used to define the mesh between start and end. In units set by the units variable. } } var ipol -type INTEGER { default {1} info { An integer variable that determines which element of the dynamical polarizability will be computed: 1 -> alpha_xx(omega), 2 -> alpha_yy(omega), and 3 -> alpha_zz(omega). When set to 4, three Lanczos chains are sequentially performed and the full polarizability tensor and the absorption coefficient are computed. } } } } TDDFPT/Doc/INPUT_Spectrum.html0000644000175000017500000003420012341371641014300 0ustar mbamba

Input File Description

Program: turbo_spectrum.x / turboTDDFPT / Quantum Espresso

TABLE OF CONTENTS

INTRODUCTION

&lr_input

prefix | outdir | verbosity | itermax0 | itermax | extrapolation | epsil | units | start | end | increment | ipol

INTRODUCTION

    Input data format: { } = optional, [ ] = it depends.

All quantities whose dimensions are not explicitly specified are in
RYDBERG ATOMIC UNITS

BEWARE: TABS, DOS <CR><LF> CHARACTERS ARE POTENTIAL SOURCES OF TROUBLE

Comment lines in namelists can be introduced by a "!", exactly as in
fortran code. Comments lines in ``cards'' can be introduced by
either a "!" or a "#" character in the first position of a line.

Structure of the input data:
===============================================================================

&lr_input
  ...
/
   

Namelist: lr_input

This namelist is always needed !

prefix CHARACTER
Default: 'pwscf'
Sets the prefix for generated and read files. The files
generated by the ground state pw.x run should have this
same prefix.
         
outdir CHARACTER
Default: './'
The directory that contains the run critical files, which
include the files generated by ground state pw.x run.
         
verbosity INTEGER
Default: 1
This integer variable controls the amount of information
written to standard output.
         
itermax0 INTEGER
Default: 500
Number of Lanczos coefficients to be read from the file.
         
itermax INTEGER
Default: 500
The total number of Lanczos coefficients that will be
considered in the calculation of the polarizability/absorption
coefficient. If itermax > itermax0, the Lanczos coefficients
in between itermax0+1 and itermax will be extrapolated.
         
extrapolation CHARACTER
Default: 'no'
    Sets the extrapolation scheme. 'osc'= biconstant extrapolation,
'constant'=constant extrapolation and 'no'=no extrapolation.
         
epsil REAL
Default: 0.02
The broadening/damping term (in Rydberg units).
         
units INTEGER
Default: 0
    The unit system used for the output and the start, end and increment
input parameters.

0 = Rydbergs, 1 = Electron volts and 2 = Nanometres per electron volts.
         
start REAL
Default: 0.0
  The polarizability and the absorption coefficient are computed
starting from this value. In units set by the units variable.
         
end REAL
Default: 2.5
  The polarizability and the absorption coefficient are computed
up to this value. In units set by the units variable.
         
increment REAL
Default: 0.001
  Incremental step used to define the mesh between start and end.
In units set by the units variable.
         
ipol INTEGER
Default: 1
An integer variable that determines which element of the
dynamical polarizability will be computed:
1 -> alpha_xx(omega), 2 -> alpha_yy(omega), and
3 -> alpha_zz(omega). When set to 4, three Lanczos chains
are sequentially performed and the full polarizability
tensor and the absorption coefficient are computed.
         
This file has been created by helpdoc utility.
TDDFPT/Doc/turboTDDFT-CPC.pdf0000644000175000017500000406641112341371472013667 0ustar mbamba%PDF-1.5 %ÐÔÅØ 3 0 obj << /Length 2632 /Filter /FlateDecode >> stream xÚ­YYsÛ8~÷¯ÐÛJU xæÍ±“¬3vì±”Lç"a»¼ÂÉóë·/Ó®Ô쾈$Ðúî¯!²º_‘Õ‡#òÂóíþè—÷¡¿¢žÃ¼À]íïVÔ%ŽÏ¼U'f0”®þ\·]}(÷ggï÷›­ë“õ­ëúëGR¦B¿Ý•µ~iÌH#ó.ã­, ý]Þég^f"CßT"ik¾ùkÿù =ºÚÒpà¡kdq?ÛúB–Ý£Ì2±½àEò£l SUU—œá³ñé ̉£Åx‘ê—]+î6ÊÞe!NŒ¨‘ɉÜJÑ•t¡¶¶¢¹ÁÞ:^di{Jð­PÍNo]'Š=Mµ;ßíNæ1µKº23u^´¢.øåˆÆëwø¢„8cáÚ ¥ÒJ×Ùדï¯yñ<Ö(aCµM+ægž·<{ZÎu@[P ‰Œm_—Ì„Ñùéþz~ÈÞÆíÉ!íL¬îxÆó‰¬ã ;…HËÙg—=Æžšheb©¯ž™4_Z8¡ïM¤M¥¥¾;‘öôÓÍöüêÒxó»Ë«Ó›óý†Fë«s–Q0ˆ%Jéú0ŽÇO­“þ”uÎDÅë6Ç<8Éɧ"—M Y ˜1Œ}.ä#²Š™¼}šÑóL‚M iÜ•·6 esüü}N?Èøâ8?z·?úzD¡:‘]Q8Ì÷!O£0î*Éþü‹¬R˜ü©‘ìßi¾b‘ëøïÙjwô›.mÑ87ô›ÑØ¡žQ×ɤåI»Kԅȉ=£²ß7Qn¹k ^Y¦]"ô2–ùãB.%Ï*çó|ˆ-âYÒc½·ªxF^e-d½Æ”Úá© ¼,@Üc(€H]êg& ‰ö‡Hu¡$rüˆÁ ubßÔ’Y•T KbÄl ´«Ä†D#ï ‘šis®¢_d„©lè"©þŠÄŠ9 ä—Lmž Rr8ðÖ9WøÞÔÚ€­»J+&àÙˆ ùpCýµ¨Õ©0øÐi­Ø…Þ–yã,X”F¡ÆþÏ™Ô$A-©4ì• ÎmSvub¸lÊ»ö›*CµÐü¦vò°qɺk­…\j8l¬ Ë`t-¢ñr‰R…kB³Ÿƒ—ךˆ ®I™We¡l×ñú7“@±bê¨pF¬nÃÐOÛ._*Á®C!=Òw»ë›w»Ý•£91,|“íƒfª>ëC-ž[Hùsw}Õ¾ÃÕŽŒÁH¨ü.WQ >ÑAðYw…™7O®è76sŸš¿ÓÏÔ‚†h¬)/v"¯×”msÆ0…[Q+à–„ ¤ÇÓ%séú®.s=“ñª-«fÊrΛFn­k( D£`ª(È÷ò:¾ ²ÕɃl!äºZ¨Ü µ¦±û걜ƒ¥àÇÄ,ŒdòP£býyK|rqr½‰]Àäú_ÍY zÁËû÷û߈Ά¹~šÏ΀"‰UIÞâŠzqÍ…L°ZÙV±d>Ò¼éãq`8Œ¡ßìòç϶ã)L­@pÙ2™Ø¾1,ýK?\‡,©Âl=áqÁyÏqÆ‹ûŽ«9üKüBoAá6ü¾Ç-ÊʧqïØ_âÄ,šjR.”›zé:ÁPÊN <åɶûz™}£d²t°ÙhRÄ®*¡%o{ÁuA_â$ˆ`ƒhl›xužÛsûËÂ.®ãyý&²è¾Pzrþżßô¯—ÜØÚ"ø/óNÒV.¯ŸÎ¿l3ùe0»ìMÍ –ðÉÌ'^Ì-s«0‡±¾¦íqÕ ±±8XDl8>Al$ý³§·‹K 0pÇ0Ïxþ+@a¤HkŽÎô`ƒÑöU5êï H<¶AˆpV¿CèЈãÙ½þ_;%ˆßå¢}(Ó’æ8R2,¶˜xµ×’mðŽ"ê¡?…Fà~‚c€/dI$ŸŠÿ]õÀhß]ë<ÑAŒãHñx‡Ú?—Í|~rDÞ@€õZÅÖì¥Ï"¼|çŽDÅ«­p­€_®­¼h3„K>Å^Ià©÷5oæ‚ôÄO…¨|ÓÖàË’kQPWäÓŸr-F Ãcs ªÑc±ãÒYœ ïIô¡^ƒÉZ4ó›Í(xmˆÆpH}:˜éƒÉ²}BÂÄÛ‹“õÈ l2ƒ—pôx¢º…† /Ã<즤¡™÷ï8¶T í8¥ûÄÕ3‰ña¾Moà©_@]EYlÿ *ÀU½ð‡,ËbÏLºþöP"vB¢ù%Ò¦¥hôlQ¶úÅÄŸž×YF“±›âŒÊ#0Á-VÁG • $^ºB€cø ˜­¯Ñ¥eU¶0y†,„º©9”ج²0†ê|›`¡©•BD) g» ¼;{Ýä¨9Å4Î)Á!4ŽÀ6ÿ6öк'Æ)h ±Õ÷hnÓ†a£aÿ¹Yl8(dåzïWêcÍð¦ DÐp©HiùуN–^Œì?6Ô^»U¼Oï¯yšb ˜dw¦ô@ÕðÔŸ¦£ºuÏþ©áÁÌv˜R7”b¸¢´0]«±‘_;1\PŽîvÀÓõH:ñè'Ïšq¡:û• ½H<Ú°à¥î-7o·¾yó!ö’»n·«eýß@ÃÝç[‘ÝK]ÈžýE7»Êݺz+ú¼¡À”_ÕÒj«éŒ­->ö?°Ó p7÷åýTÞR££1 )À`S¶¨g¤r ¥sWü/h endstream endobj 16 0 obj << /Length 405 /Filter /FlateDecode >> stream xÚ’Ko!…÷þ,Aê˜1óÈ®’JQÔE;‘*UY`|m£`°€I•þú2yXÊ"+®àœsïýC{ÄÐ÷+ç·quqÓ ÔÓ¡m×hÜ!ÎZÚÚÑ¡©Ñ¸EðFHU †Ä@ÉÃx{qÓów>†*Î霋ã'„赊ÚÙp™ågm£M_'×¢þuÒ¶òÅ[R5ëïœ?J£Ã‘’ªe¾Ó¤'5óô”‚! =.ð^¡(¸üp ?o¼~ œì24¡¿nµÜȨUü¾š'EUîl¡GÂoÁΚgÒ ü ÷v “4©I_ãÈ8yÒt>$Ó1*ø+™e•äzÒ>–ˆ;¿ÑQ΃ÌOÒC.¦Û/¤Zó[çóZà§™Ø|£¤Q“‘ s‚ÐÍrhÐvoJÒ´êŸ+ùÔäCâ–u{ý2¯2òÙÎR)Utå<@.þœ)¥;%üóbËç:Š~:.L_?éhH€êvù¡}O»!µ|MY×ä~õ™åz\ýŒpÅ™ endstream endobj 19 0 obj << /Length 3270 /Filter /FlateDecode >> stream xÚZYoä6~ϯð¾É€[‘¨yÛ9‚,É쌃püÀ–ØÝ̨%­Žqœ_¿uQ-µ5É /nªX"‹Å:¾*9¸9Þ7ßÈï¿ï¿ùömžÜ~‘ªôæþpFŸ¥ñMZ~©›ûêæÁ{÷ÓßßîTx¿|øáþÍîç÷·÷ÿ¹Ù©Øƒâf…¾Ê…7ôowIx?4cæ^[MåhÛßøöm¶Ü G¬¢ü(ÌøíûÛ(ñìÙì*Ó™¦2Íx»‹‚ƒÑ`ÇçÝajh5]= ¼ñdÚþ™y~ ’àõÛ{žxq bïþ5Oí!ºc®ø^ ™h¦oOÛÆ6G¡7eoô€Ïth‘: ý"IXê®í¦Z÷ ¼RžÆ¥òÂÓüص·*ñžL˜j¦œÍxj+Úž¹á,Li¦³ém©…y°gXtH|íém7.˜:S޽lh›ÕþŸq{Ï€|x„`-=®§²Ô;·µ)ñü8<£9>.•Ãu µ³£á¡{ÏŽHîv’§a*K3 f]ƒu8ýÓŽe´uÍC-ö‘/ìC…¯Òä%9 ÂhÊ¿È2ÇJ0¯¸æßñénµ•3êßAÝtQø*N׺¨íÙŽ¤k<8àÝã­¨Í+Pý0âiÀštƒÛ€}ŸÛ^À6+}“Õµ0Ñ9gtkØFïmMv‚tÒ ü¸e)/Õmy» ½ys&ÞåI7G³+Û¾7b W‰.ðë+¶i7ÿ núÆÔÆ–{Óõf ÷"2 ƒºmŽ»·’ mk‘¬ÎJ‘`j´¸¶ÙÀn˜d›Ñôš”¼/ðžN¶<ɤˆ€6ÑŒ wã(_”€µ–e;‘ó'©xPA S@`ëÍp02!:rW‡›ƒÅ‘&èyhe¸’£ÌüÀÌràÚÚVB£;ÆÁ‡çjoxgáÿ4—7—Iù âLȤ‚Ü{Hð6ƒÌKï˜=’}¥b_@LÙ6N‡©³*x¡#…–l0SÙ O ‹ÌÏÂhá)醧侊foáÈ qgôsÞíзg&ŽN®®Eõãd©;]Z÷ü–˜$\gpª"QëKµç®6ät;˜Ib~=™Ã2É8“ÈÓUÆ)||U#&ƒŠ)]Ûo¬Ãò€#átæµÜtÙ¢´.Ñnà %ö¡Å'äTg]~b?@À¨úW›¯yò! 7Õ°dE Yd3$è±=⥰ÔCqÇô0@«ˆaI¶ ˜»¸)ÌwºC‹§%XG`_[^ÄobS<Þ4œ$òÃ,ü'v+îå÷¬?Q¶Ä±æŸ†´ót›&-—€‰2M]צªŸçgð&°±8`ÞìÊ`˜•ÐmÔ¶1Ïþ4)‘,/ ý8\«a6­@T ƒ0pƒð‘O¶2$K‚Ò+—.m­÷×‰š‰ “0J‹1 SBɰ¯óÔ sÀ‘}Éå‡N¢Wâ+§˜ÈÇÌfÙaxÀ ®)Qâ[ I£ñÔÃÃ}ßꊇ¥ÉÌ-†(4'rö¦Wä…E2ƒ4“y×/ÁœKøîHÁÍ ¥2§4 Q”‡ßv©£!—…' +Q$[!ãÅ)v.•|yÙi` ƒ¡æŸ×ÏäžÚrŠÛò¶È¥…òÌÿ&±¥°ˆ"Dz?~‡q5¤€s$ N]âq_¨]K1‡xUø+sѵàbû¸ö¡ƒåèôR+‚­3×Ö9L#¹Ç–Š sÓl˜¨RÉo©Ü3Œ=š=‹ºž(k¥ Þh~&€ì‰Ns8ƒþF.Š®±¸Œ âXÏo\ô‹sa|·u’0AmG*%û_;-E¡hAÀdÌ×A¸ˆåH'™ªù‘ƒ4“JÝð`/k\ì¨ÏL}‹Ún'ðŒ^–!žÿ¬8Bo„DváT¿‘âx1šñf"Ñp$øjñ.Œ%‹{àGNO°K{v”=ìÈ\süá; •puá6¢`‡KМ~šÌáš„ðôw#´‡ÄÿÄ1WÍ[5]cŠœ¨J¢ÏS?⼃ÕØÆ8õ{R?<Š6a$IL©­'WÒ0– F·€+Öò|Y–D û=˜j=ðäC˜Þñ($D•a¡ça¤|IÓ²\è8|©Šb`Ô¨jµ ¾§ó8ꮃ¨[žÈ£bç“0¨ìPNâ“ð*!K 0,Á{ Ï£ÔiøØô²…>]ˆn®_l(’´_Ìüa5¾:Vq‰ó䋪ˆ—ªžìx²ÂÍúÏbòMx«Â¦â©y‹w¶>CgvïtSþÙLæÚ–ŠnNH„ Û”Wà!þ"¨_×\-³ObLsêx4ƒ‹1p5½=Z!4º!XÁ³V"+=M2@4Ä“pQ£Å~ÂJÓ0q0Ì×ÈF‡¿€XÅŒtäÐÙ±z«ø™²!Mz䑹s Õ8—ú )§ü|‰h¥üW\Üã‹‚ÈÈÈ   ˆ¿+ÿÅWñŒYE yðÃFŒ;ôÙMSâ;C©:¤’É0UsµŒ0{âxÇ6&¹ùº^I•_ùWTö3€þ«’RZ6ìpEáRÃa¾ aôÆÚ˜^¦Nœ7wC^¨ÁRƒ¢\˜æ~ž_õ(Ð+¾·–JHǪÖj‡õ¼PÅÁ€îW¹ZŸi[]-¤KøtiCsŸ Wà>×û{‰ÓªX9û†­>„¹½èר4f.Ĉˆ! 8R®Ü@â“a Ï;z†Éš©|뎷l+´8%lÐ͆Å2I)ظˆÝÝâaÛ{^[ò£`.mïD6ÉÁèÁÉo\ŠŠý¹¿#ö¼³-BkTp¨« ˆ\ÔˆgD^++ì ¬8 °ÒÛ=&¹‰\ùÀ,sÄdàÀôXcâ4ç—9§_ßà÷ïßÁÆ ³lÆðâ<‚CÂ1Û$W#€6¹Òˆ%dÄ.¶À࿲•O¸˜Ãt‹X»!ì¼¼“HfgÖ7ßxóñãO¼6BI³Þ°b³w•2Á^ƒ®ÖÙ¹Þ®š¯ONÍ;)Ë$@g¹Àû_ŒÂs7˜©‚ø?Jg ˆ9ÙáÀóŠÚÁ0RêŽgUDù àâ)MIå)æ}’ÝÀ6(pÚÊ0§fúÙ6öÌ»e졆sëÆ îuù‰£'TíÓèÙáÄ ±ïܴ㜾sé¹¾ @*ˆgYnQÀãþyËé²aþœî;^ÕŠ,¬¨8O¼HZ©Qá+uU}?Q›8ƒ 7”àÒ4fÌ`…:žÎü8{±kßÚfãa¦ü N¾þñâ´´±ùØyâ…´/7/b?O¾R}‰¤ŽS¢¥,öU𭵄›Æ+‡M¥s”º¦ ¶x}­¿¦jÃ]aåU´s#E)VL‹¢’ÈK˜@ŠWN±’Õ6°"ô˜÷àzîaXø±ÊÖ1ùÉ–+¥ÇŸ¨¯VzϽ¬VàôÏ?þð+¤©‡Æ źƒå|@„å)žn_pþ™ÁÕ Täi´^©¥¦AÍ<÷òˆ»"¥Ïk|ù7'UÅ|R Á¥€¾ÿ®r^p,€ÿeVŠPÀ@p¹c;>w®R P]-//+²¹½Ò‹l«ÃˆA$Ï\AëÊIW VëR×Bž˜Ée= ®×+ €Kè‹+ÆÑ8˜ÂS‹¾õŸ¤^}ð äóeÄ¢*,"á•áÎì‹:}.î;þ¸‰X°Õœ „¯%ÉÜ! @ïMÜYZžiŽ÷ý¡4½ 5jT¸Ž×îÒÕ@8óHã¾Ä\º+¡Ç¨Až\OeûNe–¥MwÖÇÆ†¥åte/Ès«mhã¸Ð*ˆˆz2‘ûì‰óÏÅâàŽƒ=ÞùƒñøqbRS±Jp¸ëËš"o ñeQ.5E€ñÇ 'Ôk þß7 ˜7 ^ÄGp/sŒúׯB©óø"YBh$EÛrz3ƒX|âf)|Å)M¥1hŠ"?Ž®üíb è¬gùŠJ_¯–BÎ6ä¥CÆ­9H¼ì+…YéfV¯Ý8¥ò³ (ܹÊð•îG3X× «loÊKdâÎÜÜÓ“ÊgnȱÉ9[CU˜ÚÕfN“,_çFœ‘‡­xÅPoõ¦9Ž'ʉ³*BÀ'ÇÆáŽ'~>¡ß·O­MëþaÙ‘$i‡*ð·#Uœ±ë‰ǺÚ~igaúÉþü­¥ùŒ×øcn¸ï霳Îÿ‚u ~㹂&ÑŠéÍý7ÿý°;K endstream endobj 23 0 obj << /Length 4239 /Filter /FlateDecode >> stream xÚÝË’ã¶ñ¾_¡œ¢©X Þâò!Nìlb—S©J¥j=ŽÄ¡#‘2IízsÈ·§I€‚3™u\¹Œ@l~wcÈâaAzEüï—·¯~ûu.&3Š©Åí»%*ãR.”!™álq»Y¼]®›òæîö/0T‡Cy¦™8vÌ÷„*?(„§3ÆÍ0f]•u³bœ-«ù²ì:諊íö£{Ñ?–®±o›Íaí‡7ïÜðñí»¶üñPÖë*—×ծì" |Y튇ª.Z?d_´§nªâ¡©‹­{*·+ÜÌbÅXFT¾XQš@‹ÝF¹ƒ%ãL‚¶%iZl“eßë:¨{e§€_74öͶh«÷Õ¶ê?ºoÞ2q—ݬ8É—®‡ñ•¾/ö¥‡ýÁÃ(6›pA&ËÍǺØUk»úã‰p#$Þ‚][®—…ûÙ5Ûr}€Üc÷±ëËÑ»SÕ4¢š1ÍÆsÝ»}¹qÔ‡õ¶¬¤ H¦óñ›Ï`´–Ë¢öŸÙ Âï¡+‡‰Ø’k#–_ÃÙµå€_YWö Ù?¶Íáá±9ô¿s ®ÖˆŒç|˜ùß ZÖ™‚Sö¾H,ÞdŠÑaý<“ÏE¦©œÑJr2¢ÏÏe ?;æTãrvã•™œk‘g`¬h&Ì™•ä“t º¼ V!åòMU¯ñ ŒöTõ¡mƒÃCµÛo-£}ÕÔ®¨Î‚§&Ü ÐEÎFºèí}sûÇ?~}›XŠd'bÚ–…¥Ýí«zœÑ·Õº·¤h:î<'+ûœ±rSƒÜQÒR£ô\¿%Š•ŸÖÛÃÆwTµûu{…Æ»f»mn˜\~¨ê×…Kp­ýþ¨µs–Ýð+èÚ4»áah5‡Ö5êÆ¡«&ñýb³Z#3Ãb3»!Ä ws;¬îHÒk(<ÈǃWUÝ— ÃúqK%ˆ…¾׳.üï#<íQ"Yœ#øÎ³ ‰™«L©­¨ÉrmF•Á¤+3ü’nu³¢ú‡Edh'‹¢"±žq:2ø¯RÒ)ÓZNÊ „Ì1»(`\qžséDž·7\.[7ŠÏ¸7ç :˜ÍHrsZ—Rí2JR²´”ÌíËÝÈ$0‹ëÏg˜=ž•gÒè¥ã¤J„Ð÷„37ˆ™è0 Œ¥Â#‰uÑŒµX©‰4RGÍ2Ásø«òËG­/µ8>ê茽ÄGD“ÉŒ@i0ðóÄŒ”ç×&˜“ÐabT ΅㌧ekå*¶kK'çÀ ©7 ç{ÿæÇCQ÷äbÖ»rýXÔÞ €—  DÛî3; ÐP¦Á¢ hä5é§P“8MMÒš“á ¿¥Çs3‘)9N•$ƒ|däUÿèQÔìöMí•wÍ v tl*‰¾íM6§¤Ì”ˆ¥è¾é*ÂÎÒà¹1y¦h Éø)žÈu&‰¸Š'x¦¨zžàóæSðÄÌnáF”e2Ÿ„èÓÄÆŒ¶(‰%ÕéÝ_'üŸ³{f¢1Bªi I lìŠ?çiä„Å¡ô àM ›!íZÀ(i`‘Î?mʺ³¦ÏÕrW€ÙôÓyʶülvo÷¥5`pgãîA8xŽS\tîÒyC+ G ÈÁ¶´rûXh V¶AH ñІ޽÷ߨ³•ÀÀ²N&ö<6»æ¡¬ËæÐù!vèô  1Vn7î•3G7Ο5º@èGñ%¾eý`Å!AtZZt-  o¨›XrŠ–Á©—F^ÍùYD Í憃ݡ{êHNÁ[=#¹C ctØíoŒQ؈qxãÜ!Ût ;3F&ŠÅWÅZ …‡qï¿››ì Möì®Ù¬×v*rzBÛª.GbƒçÉ&‡o«æðÎ~ðà¥wáé­ñn%Cƒ vgÝ J†~޽¯Ÿ,/"n2bt$Âa»lùmJ’£`T‚Ì$D"¡i^©—ÓhIË—³¤Å/ÍizkOŒ2&¬¥z½ß£O[ªyF9,ÕRRaTKâ´%æ,¥×çSOó¼~Þ]¢ü¤ÂÀï6y耰„b™,c¢gpèlÔߦFr UÝL^ Â,ÕW8.N¿~6„UP%ÖG‘†hy 1TÎâ@÷ŽÏOp(6ôeY4vvy,4”VîDÅ µ’1I£Ác’ÿ@¶\0@Õ¡G÷:±þ|¡hýQÎÈÍ(máça•V#¿13€ ŒNc×QǨ‡×¡³þ›(páä%ÄÃD ø®Á<›)ö¥ÿžØ#ðx½Â$+  Ã"éþúf•y@îË?¤i›MÞÂXªNG$ñŸx3ƒç’ȳäÒû$¬9‘ö,îƒòö˜ŽfAtu1èCa{a‚LÈ\•g9QVPQ•¿û^öÁ“å±ÏèNC(_è™q ß`0³y¬Wo ´íDn7ôÍ›!ߥ—¯‹]µí›ÚIsèxËî†Ðh`"¯ ==…].DPžÏ.A<奨åx­)v FÝ9Œ3·]{Ý´-xŒÎ †é›i°ÏyçÓY–À'ÒVûí¡[ýãCÆ wyØ!òØt^¯›¦ÝTµ :Âs[¢÷dv0s0èâè4shj˜ƒzÄóÓûŠD&ÀÄ¿`Ú8ù\áwdçjyêÛÄ9ãÅ$§VÀ°I{ÐLø5±œÄBÄ =ÔÔ#,e#P0“ÁЂÅ.ª iDä˜Äέ4uy<öê«ÛW?¾BÑItÁ$ ›š…nÕ ×»WoïÈb/Á ¥¨ìÐÚ€’"B¶‹7¯þæÊb#q€Et&òÈæŽ0diØ ó³¨›âú8ê¦å\aÁ˜“Ëtn"òŠWì80õCÒ‚„¡øá"2 "j ×ó=a"A̰$£#ä4X ý’3T¬/Q1ŸiÛpàâ;…I‘`ÔSª?ÖŽóÅð—HÒèÖ !Í´µ@+9öDûÂöž U®Â¦1×`óé'Ǿ“KÈ@MOáf“ØÌ˜üt¸‹Ö ί–‘k,R¹9„âå1ÆÁJ¯üùž2[Nr”:SCZK.»fµ.¶[Wï –V™C÷?o(Y–m]n]ÿ[ÊïÜ›þ±è?såF¶XÁȘZ›ª¸¾výÎKÇþý¾m~ªvc!‡ËNÝ `üšªz3FØAÝ‹™Ñ±/á½+þ"cHLV€›'„ûmˆ”û${±v•_>‚¿¾zÌF6ÍØ¤DáY,»Ãúѽ)üH‹xþêG?Á˜«õŸ<7Œ€Cå²tC}ØÔ,»b绊íCyßhøíਠŸw”4ã£@¢Ê[|Á’sá¿£½ínµ•SäLyH:#ó+ê xìÊøG˜å¿Ošå˜ŒØ X¸„G¦î—‰MH°u:ÿÎcû —qþýD4ŨGHžBˆ13Sשׂ2¨»Î/â&šï‰X›—xˆ9Ö,Qùr<1!B È}Áž,Gòìúö`ë»¶1Á —ï±Ð¼CBs80#ç ÷¸Z œfË4ö·N`Ccšu 5ñ1‘„‚:£HÅLÉ,}(4} (Î<æý ]ºR6÷`“€Ì»dØhox¾,»fûþô˜0Ô™P¼ ür=ê ›Á¯(ÁâP)ÄòË^¶r™)#â4 N=ÖlÍ3©ÄËþªÞÆò®àg0S…eCÕ›™x:/º”²¤:ãèÚ8­þ?*›eœhXBR¡Ë| üÅ«Á®«ßÑ©j°£¬ˆ ñ™ch~†É²kþ ²sÓþœw…ü‚¢È&›|ötå…¬bH)˜˜\:ÎÙKõÉ-yMrKþ¢£­'Êì´M^Œ¸ £ˆ«<•åÒq™VÝF§ÏI&IPºGó¤Od&ÿëó”ÈA›€Ì¸ÈȘ¨íº†’?[U{Y ýÞž´í鲌¸/ûeY»7ýÔk{ˆì_k´ûA#ÌÒ•”0ÛoŠûµ‚3|±¼–¿º¢”•ÀÊ‘™Á¿nmW¢ãn4í/4`c•øûPaõ`OcOá~>”Ûí*XöíÊ¢vµ=#íôޤùtÞ~Ö3€æ1L üÐõ©Š‡{[ëC¢•â'Ò¸m|×ZÎÙcL—º^êb…!4[Z‡Ô¥´:• Ѫé©ÈO•Yõ¥øuîd7 kv[ê¾q_®Êë}ìl ì´^ˆ÷Îu 5ÎÆÓÒú‘‰§%•ÝàZi:ŸÒ×½Cc$qh‡î‘Œ¨ñ)G³U~“t+FNËåí8â˜c®ekchS—#¼%¼)׎Šeôrþ5ó£ŒwP×#úxëz€{\~ †=ffØJÿ̱®Ÿ!öÈŸñ9­WψÖ•¯Œ;KEpV Fsó‘åïÆQÖOán{ÊÞ°>’çç)\ d˜˜Ý3˜*„sBЏ|'1x:’ØûK\în€4ÇÆl`ct甜²¤qMPRr<¥ï’qI%äE*E½uœUÃ?hԇݽÓÿwø»^ö•?Óº»Ã+ŸGèfËw蓃WÜxÌýk{QÃ_í ’€ýÏb”û°ÀxOHú»áîn‘½^ÖxÓÚÿ÷ŠðjQð¯l·—Œîå¤nêÕ®x¨Ë~¸,䯺ƒ{ªd¾ü®éýĘð¿×ô®õ Û™—ý_ %À+ÞÖ¿VÿËÀÎÑ1…ÞÑ1U6A”¸[$r[WãOˆûDöTëóºlwU_5zÜ’.¿t—º¢E|«lm厙ãà¨;Àþνw§Îí•wxAú£S^¯G×[⫞ÖÕî}-:¸í½”Õùì[ëÒÿÕW~úÉt"r: Á’0ºúüÔ…¸*:~œ«©œ\²(WûEúÖ#›\¶§Uz_³yv¦äò¤qø4Ù`Îøoq°,m.FE4â«ÛWÿžu endstream endobj 31 0 obj << /Length 3667 /Filter /FlateDecode >> stream xÚí\[ÛÆ~÷¯PŸªE-fî}H€$H íⱊÎÔAPwŽ× &ÓV|FØë0B\ÈsŽüÀˆcˆŒJz`Ið«Sš:fÄÇr‘gLõŒž¿Ú;ófô³Ü‹ ×”d\Û±^o‹ ˆK> Üí›Û€É8 ^7ïýuY­Êe¾+ÚîV+òå^‰žãxÐó›…$dJ@˜f™fJˆ:+!zZBtF)JÈ2‡¼ û]>ÔmѼŽïé ´dFf’Ș–»‡ú¾®ð¸Ì(÷<~xcÿxåëår¿-‹Õ¢ÛWøI›¼*ïêõ x(¨‹_7a¡Äi¼jмu¶Ò†GÇáƒ}„?zûÓœY„1´Zxï½·apX˜ý#:‚‚͵euïïu«âu±.6 £l¼ýÙà—ÈÆÿ½h¼ u‰hȧˆFì?E¢‘z³ÛO0‰%ÀÍf`»æhÂß{{Þß;^!r3Þ&Èï•cVG{=fu@y.s1u^¢±Ý–úJÓ‡XNB<íÏÑ0«ù;ˆóŠtF˜päh©œà8’…9ÔžãÂÙ¨ŒI uí=)`Ä}QM¹ôÌC¸5ÁJ,„‡å“§,'¶1¼k Ac‘"+„ŒPozÁSÐd‚ BfŒòGÇn±g©J4;'<ŒôPá©fõ„Ä›­ó„”¢¢BÁêuYW«ýÒ¹¾‰XGdL‹cZÇ4Ÿ¿öN\•|Îÿƒß6{ðî2aÁ~ )¶O†tþ%ÕƒØ*ö/§%û*xîEÈ‚8g~{†Fi•ËR*Î Œ¼]×Ëÿt 7@«}S¼p;¦Ò}`ãø€¾\ÉÃô b¨ÿF̓Y!Òâ‘°1{è 3;Rw/$-¹–Î`BhôR; ‹9³O´Â§<‡¾"=5ìqa3aŵ_¹L"#Xî Iˆ ÔŒØ(‘ÞÆ 0k1$ý‹”I@ò(&º ‰A½5˜|q+˜#ô ݯo\ÒN&¹d™DË 5X†ÒÇ¥tž¯ÛÚOz€0+@†s¹¤5nÌE8Jû¸Ï½‡ƒ:^°Ð±}w ½t¶HQ6ÿW8¼Ý÷ à–¦Kñ¹ÏÜî׫nÊã¾l‚BôšÑÅóûÂ?Qß%½E3Ôâ*áœ[0ØúŒsŽiø0#Å p?ø #“ìÄ¡\{~ˆSü àß&-ë"±mÊ3ÃR/Àþü±e²"HÂ:à Bï”3f‚¥…‹ƒ`“À˜Œj;’ÆQ1C‚Û‰C´üªÜ Õwþ³ÞŸˆ^_‹b],wŸbæ·yë<˜ JòÊ8ëïw7—kÐÆõ{?¸Añs‡·àÏXŸ}S;)c)dÀqÒéóâ祚…ZŽvšÌ<<¤M–Cp Õ‹™ˆ`a‰Ì0û†&ªÓƒIP•zÙÊC¹rì&¼¤¤w§þAH+‚ºež}óúÙã3´ dFÁÄž9D€Ë fËͳŸ!³ÜüaF2 ¬|ç¦n Èl={õì'߆‡²a)nÁk´62ï‘âZc¤Å]>{TÖ‘Á‡Ò†‹«”½3‰Ì¹–Ÿ¿ìýÁý‘(ÈL:þ–vô WêÇŸDH(ûŸêÐOèàÇ5ˆ¡°â5®kÝ:â-ã±€l÷‚Áƒ£¼‡äŽr &Àá¶OÀõ'ã–9‡[ü*¸%/Ä-nPB^·4¶ký [Ÿ¶F ålMÐòOäú=‘ëÈÇž°¡`¿8‰oðG‰fJް «hž…!\¥:T›¬wEÜøÄ|¶FòéÄn+páûÎͦÅv ß;å3ØNÓ”yhß·»bÓ·ZùÁ¸‰jù¡75óûp·xÝMßÂÄú6¥ßûæZWBô›Ltü`?g{\NJ(¼a׊>>8T<åÌ÷}¤>à_×U‘rªN1¶€Ùõ Ò“£¢#†’ÇØ–ªEfý^Ÿ‘SÀ¤“}6£¤Wn‘Ð9La3„7ÚÑ?UºƒYHJ&ÔtwƒÍ4ü;—ì@ðdÉi{2ê±¹r 3ÝÛñx:'qÖ~:'ÇNö’&‹p [ßcl¤ƒ„E‰& Ûý‹íßuãmÞìÊ呈°ùãPn¿ñ·7ÀX‘÷Úßqඇ1¸¸ ÚßñVîï´å¦\狳«˜UbþÚÃØð^}ý2†»ÜÿÜwÇè>ðå?ü«l»£Ï™®F™E©2A™wz-;WÄŠé°2øUªpžŸAW³O~ÞÌ¡>“9$J äg­A>i àßβ>vìÂb7=ÙHgÐ@è.–?äQ‡ÎæqgúÔÎ|S/ìLÒA3[€ý`.*ÒòÄöC‰Í;=XºÓ8Å•3öȽ†ö觤×h`¡‹_&ÌÛ(8D¹(,–—x„ê:áG§RùÎQ¿”Ä5™ç¸Gí•Ùg/eŸN±/â²Ï ¹“ü Ñiôb0kúó»k1Z~B×?‘˜ˆIÇß^hï›2<¹ 6|Íc§s´„úµ£M€áæ$i¥¯„“´SLœöƒN0ûiÌò¢Ó«A:5pD-®éšfÿ‰èŸ;Æ ¢_’ þCƒº¸ÔÅ% ~ ^ÿAý(}ÍHŒä_ž‚~«²QòZ$“× °Wºä5áú‡_>úp״뚆‹mSÿZ,}Ó4üYcÖ&ä¿£™Ü}–€îÓŒîX~kÕüû*,µ+”›­ÿÔ´k£ƒÅÞ…gsü0÷-þS—«ÑÖ–ù:|RѲ}Q±Ü¯»õˆòmyð¾ÁËîó N´ë³Ã±®é„pñ¢)üB!/dyF]I梿e€‰:iå0‡#.y#,ebXÿ>*ƒOU'*a˜Ý¥—½Óp½óŸIœ˜’ç¾E²o‰šqÐdòq'—¡âÿ #bh‰ßÄ—²‚(!/0P9#ÀFš²e4¼ÿ> stream xÚí\YsÇ~÷¯€ó°,¬ç>Ä8UQ$ÇŽ\9,=¤ÊòÃÉU@€Âašùõéžcwf1¸HH¶«üBìÎöîÌt÷|}Í ®dð·ÏHø}ñö³/¿Ör`+«˜¼½Pb*!Ø@Ymƒ·—ƒ†ï%g?¾ýû—_šŽhe¸ŒXE˜ñ”ÿòdÚ$d¶RLCoŽà+OÀiF``ª2Bg_ÎTe5tD¦bLb_ŒOõ–JTÖPŽT¢R’âÀˆcÿ©ð­‘¨ t=›‘ÁÀ;2^Û¸h$•à2POÀl23Y)!á;Ü0OôÞÙ”ˆVÖòø•?¶_麯( _Q4ð硪0-‚3"Zg3ÊÆÃáJ X™ÓÜÆ£+Æ÷ŽÇœl<2Ïû–É 7¦Yž˜eÃÕÍÄ_Ü-æï'ãÕ|áoç³Õ¯hG1×wÍäÒß-Wõ*<¸­gÍÕ|zy~6â”à ñã—“w„°Y³jæ3ÿ±ùkÀ4 —ÐA¢îÛ,&²…ñïÂÌ(©(sO'õbúàzq)+!5(2(‡”žb1ù°n¦„AÍ€Ø]ù¹J’ΚÝ\—%}㬒šPãL¾†Ò9*-w¦žèj~¬çlø¾©¸b[¶\ØË+úê°à_Í=ÑÇV7Z­ÙN}4¤¶® S’•Vªí~vYø03òIs• ƒ9È0Þ;¯¤’Œ»‰Hº}"Þ6GMäj=£ÊGõºò¿¯>,ƒ´ÞI(QÔ?¼o¦SuTp1ùa2n*Nx®ÁW“Å©§€5Œ+Uða½ ÷Q26) šØbðúîn²(L„I`wK…/ £¢"¼Õûe¬1­ê¦ÍÏ(N„a­´³ï‚ƪÎPLç÷Ûɹ=dZ·dwäx~{7ŸMf«¥ç°¥ˆ¨ o^|ï[üy}.ãNïC8º3J(ÿRª5l>áÕˆÕR«€sBW‚õpî[·Ð¤=éX´É, èkí¾™,nðëYÒ8RA†Ï|°(ªÑ+ß ®ÿÅtrë½2ü' o‘£w„xpàÅÙuû9÷ûêCxEŸ†8Wæœm0£Þ¡†'Ëç%Y†ó#‚¿ySd6*)Wtð`óàᛂh-™ƒcÙ×»¹ŠG áyѯ]íÀ²/ATMíÖgEå$ЦÃ"%È®,0A:ä÷渠¾L%„GÀ©>1; «ÏA‰ÙiLL¥ˆAž–Ò15Í-S:0ŒþïÒú[}H2k–7±‹H>ñúMúBò9Oæ‡è" ‰É¨“<&ô9-ïæ³e¸»œÌ–ÍêÁßøá¹ä”ˆ±ŒqÚgPùܽ~»òÔ>CŇ7só}gùËu!ÅÄ ŒKž¨a½¼ëÒšãf2 }º/üŽëéx=õ±/6/ê±/KÀR0Öd/ýç¸`-x—ë±K¶Á]l A(6¶Šƒw÷Íê¦@”0î:&ÚNÆø Äõ>N„ûPA²^øþr¹ZÀˆÖ‹I>&dAÄ( Ý ƒ _<ø8r½lƒÑ¶tkãY¯én>…°õõE3 Rï¯x}È.xÇ fÌÇ»ýgTµåFÛ+ ‘J`xÎX¥cÉ$΋¥ Záü3í÷ˆÂ§ß XBýæ8•ÓÖZ|^4vII¥s-3E“ÓOŠf†\/’8nÑaîuÄy[C¢\èªÛN‰‘rÔ£„ð碷+° “q³`*ÁuÊÆóbe€JÚO |6=>÷XD¬Ùd‘ÉM)–ÍwE©Ke7…•™0?’$¡œÉãˆ*;„B˜[Ï¿T#5i-õCQ³u\~_Ì^8QpüZñÓbÜ8\(™¦€{`JYG”Þð LÏ9E…"é’Èt)¯Dµºˆž:“•Ñú0^‰íÅûBW#.È–Bã.!¹C¯@ñºQyG……Ê^x.róºô¡ŽPG™8,'N`š“ÿOˆ:æ ®«+~ˆÕ.,•lLèdŠ’x¶ ŠØÒCÂâÃbÞºF%„?&Z%™ þ»f¾þ©™N›zhÑìOƱ-ðó*·Ï«¤\7}x* X3—¾PÇ„>H;ô&¾cŒ)9(t ò?mp{P¥ £][’íÇZ¶$ίlç?ž—´­ÍÞ ’yM+ƒKå㪔K ´’™eå¹’šçuªòÂp `ìÖ•ƒªm:aÔ³òÑ!7LLsÜ”·’°CsVí¢1»á‹Ÿ¾~Ïn™Ý¬–:¨ºq|r ¦aÊåããàE†$YIGRô]þ{¼ˆ}ð"ö%š=†8P‡!€Ù”Cï|mîlxB爵¤=•;H ¾g|÷»­ãs¢›¿°=ËðÔž‘-îu‚¾l³NÒ² ­*y´±ÉYöÝ/ÊÛZ5dE›µFîui ¦>ô[Ï1ºcTPïTA­dÏï%J“oO½DTœ¥±;L{R¤D‡9”÷RTK¾ÏFŠ’Sþtç£_­1YªÝÜ‘o'ÛŠ»,LiVnµåÐø‰«¾÷«.§`ä¶ÜÍ¢˜˜@aŸ»éeÚ+¦Õ)wfIzÚ PŸÆÙ^ÉÒÛsûRËC*²t¯Í>òMnÏ,7`që2‡)°B.„êÊDV»/æE N†k4Ãì )+#6vkç˼͞^ïûÈr»Žú;¶®õçe„N¯’„ëËb>.±,.±5BËXr™À¾u[ÇÖÇTÖ·,{ñQ–=Ûš÷½.à׊Ó]ç‡Àº3§‰,n‰÷{θß[L*B6µý}pè‘~нY¥=áöp;Ü…à÷ÕÏnöý,cnS}J…{ LñÍí'‰²Ìwú.R𸛨L@”ñ‚ïÜÓ …ÇÌÀªë¸3ðõï+üñ+~d\¡¦;ÒCI0Žmà)ÄwY[àŸºw-ÛéJß{^®qÁèð°ŸÍªFvké·möy^T± M<Ë•©äq¿I–Q$ïÇÚÝùMÆí“›vrS»®,܉Àc½Á&þ6m߸>r?b‰r Ü!>ú«åÁea<`îåc4·°ïOuÄ3Üö (þÕPü¼xî”7ñç»ü%*nò”†(¥4¤rÞçˆYç¢9ꯛY=>œ)9|¶¹$b¸ò¿Ëq=­푇¸#&lý›i²7rªØÚ†*Ýf‘Ť¾ô‘ÉÀ¿5•“*®ò·g\FIó~fˆ«òö‡žWM;vë# õÓ1à á§ŒÞ÷Ï 4ÏÃú…ÙBH Ê'K‹ß„>ÿÓŸY— Öœn9Å`䨉—z0fqEljvÔeà+…`Æ¥Õ»ÿs‚Ú÷ŸToOG?™ÉÜÉ/U«e/‹.±ÆBJ"¢ÝGÂÙ㎄›¬ÄGòé?p¸xbçýh ;§n߇£zUÌœqo3ù¢¸ýOu$D/‹;d(ÖÞ÷0³;›NŸp6ý)=z=—Õ ek·¬³l9&i´Íò¬üŸdºÿA’-6V÷ŽüÛ­Õ²ó²t:ÿñbßÑðǦéŒp[öRÓ& ¦j0˜Z¹ó "b†Êˆ^½ýìÿs÷3Ê endstream endobj 37 0 obj << /Length 3414 /Filter /FlateDecode >> stream xÚÕËrÜ6ò®¯˜ÝËŽª< &•ƒ½qÖÙ¸v“XUI•¢gÒÐá2É‘ãöÛ· ð1‚ìqJN%’š@ýî[Ü,Øâ_gÌ¿Ÿ]œ}öu¦y’k¡× Ît"•Zèœ%¹‹‹íârùvg[{~uñïϾ–|,²„q"Õù3ŒE>”‰J³ÅjxMP†Ï „6€—(ä™4&9´SlЂ?V:É2ìý˜Ï×ÏZð$ƒ^ôEÉ4ኇåobêDIý>U¢XŠ*Ì­CpÅ%¤ÃV˜by„€bfŠåMäÌéæGÎ nFÈûGþ$2›JË? ×v®ÿÜÔ‰³/@Wðï²ß¹|ùêÙu5n· m ˜‹„ ã'œEb%©5¾ȧL’ü^oÝõÓôvöÍÁ>ˆ®a HW®lÓ:ÍS”ÛC:wþÃ¢ÚøMwA4DÐÀÆÆ»*ܨ„(!‰²“‰™DLõ01D7ùbDXÊ峪AvF„Á°÷ÖIn *™ÎÕŽ®HK?”õlóp$Eµ9TÃÆ‡®xΑåNy|˜qsô3&{ý>ªN¸íŸþèf>¸HRÐÝ  .×ÔÖ:WóÁ»å:²¤sùY–Íœé#±KaQÍ¥*ojn¦Ø©X*¸o°ªŒûšÙàk®¶eAn…›”47}[ÒQ_Îs,x¾8Ï̱©cš 9F€W â\¶vû9±YjðuWàÇ*‘žÌeæ½\ÆOU¶æ÷+Û˜,ý“A¸ÇÕ‡™LejÎdfÆd™ŽÉæËHÀñ“ %x ÀOÑÈ‘ùÓ¶M$$É]pú•…@òuä@ýæ2ðéC'`>ú6ÑÈ>×éäÊ]Ÿ,òƒøäŸŸ×Q‘yþ¸⽜ùáÄãÔÝ)„‹¦M4Ï:_DN’ ‘È\jj5Ì`zdwŠ~DéS˜™ŸÂÍmUþlܬOáf>7…sm-Mðù2–ÃQ‰€i@«§!ÇÈgÏ/ÎÞœaj-À¢e2QJ,Rúj±ÙŸ]^±ÅÁù…!³xë@÷ Æ—ãÕâÕÙ÷‘tù0—2àâñQŠ¢|'Gaü{ä4S° hŒL–è4ÁMf;ˆXàÜ&‡ 2ÃÈîüÑ1º‹f£ÈtÌý *—0± “ýxf­/)›(}šÊó¹#ö"²àSð-¢ûÉïc»š~ñ€cýÑAô=}s=퉄ün¿èÓ*¤‡91j_K2Íìk³¯€Z·D;Z<‘9f¬xÈûpLŽô–”.dájšèâ>ïÃÕ=M^¹Žž¬ú¦¦ä!€º'Î{h­ ® âà¢r¸æñ¤“¤Y4ëL&šrOð1Ù19ÞÈw˜òÀmÛÜ6-z!sYÒ«œ5öG9OˆÏŸPl¦@S¥V"«cQä+‹üQeÑ;Y•L}bϦi[¬3º äÖ%)a€¼wCƦ›ÆÛî;úܺž`Öþ÷b»õƒ#ÜOUl³ài®LͨL/¥ô±‘L¯\¹g1­O¨I¡%E5‹4ÞX€Ïü®,ábÈŒ¡Íh.¾úêë‹X-Mt>€:ª¦÷uå …})_v õ~´mä‘;|4¥âUÞÑø…RÌq]Û–rÖ&º+Á°9Rà_å­o‹²í|¾vŸ™ü~¥MŠÌ„^~ûŠÞ£ˆ©úT;ì ´è †jÐ55g8°)jJÌÃØÚOì« Ð³-‘»¨tu6™ÇÓÉ3¼ÀOª?uïKyb ?-JüëgÍ£dW23‰fïc¾(IÅ‘~ôáˆo*=:Bk ´ÄrýŽz»¦ºsº…ï³½ŸàšÞÌ‚u7ø®ëí+í2˨Z½ÎíéÂR¥Gä{õ.——Ü\Åt•„„SNms¸Ù9üĨßÂЃ¬éM³*`¯Kž_ùÏ b9~ŸåÜ?07˜ÛQ+p5éF|ãåpâÊnÐ)=l_t¿xº7v¿¸Ø¶^|¢ˆJYA5ÞWP~¼Éq»k@ÇâL ±ê¶i¶v®J½ëe˜v¢Ù0þÿÎ%VßP5G–N†Øƒ>õÝÏ_½ú¯Ï€•ÝÌzU-ÄU(ÈÏx”çxTº[f| }Uþiuƒ¦n·¸¤.ÀæSw„Ì8÷ÅäÑw×ˆÚæÐu„Wǃ–$>(›CG¿td}@2*k®\ °©-²‹ F®éq²¦*Úò·b]Vd­q%[w>rXEL•G¼üá )¼=K·¶ëȶèázIƒò,£úØb®K ¿Â5½‡+2€¨§½€ÑË—p†weU•O*™ãÕ àŒ•7âøg°ù 0.*§³k/QÃ-ià]ûŠ/4N–zwco¶¤=~ Õ-øžT·´ög®É~áÜ9 ¬üþJ€tŽø §#…Äx f)¨ 1즪;ÖÏ—AÌgæF(WõóDiÏ%`»9´xi§dioAóm#Í„K¥†û}>¼|Q¼Û6›_ž„+6 ÓžݯùÏÌV! ½”ê*v{f|•©t~‡F&ÜKë?g`Åf{¥Hw.'Ý“yÚ‡kVL´o€³µÃK`RHªãCß¾@;Àrä…=uy†ùË2ø1«R#´3XSˆc¹Å>Ó`˅ǦS=$â¹pJ%8WŒ]ƒº¬u¨¶”ðõNl„3…À"èYá\°ÉíÜé ?1댩£™S–OŠÈLD¦É€Eæ˜sa³ ¸SçxôÚS9‘µ¶§±òǹHÌÈÝ‹`Ÿ%ùTë1Å~8€—Q¥¨t>‰,9¡D|Øb³óafšºlÜüÖK,mŸ¹[³¡ŒÑãwV…Ï.p‡»uðqÝÒ²K‘Œ!bÇÌÑ©å`ÌXU@Îã¹SgnuG—wÔÚÚ=h o^¹÷rðË™¤« ¥¡³+ó¸ú´G§Ã  >ø,ŸE6£OCÙ¾É Ô‡ýÚ¶Ãñ`ê$\ïÚ“Ì‹M-I6z~qö‚¡Úœ endstream endobj 41 0 obj << /Length 3787 /Filter /FlateDecode >> stream xÚíÙrãÆñÝ_A¿Qq<÷±[ve×GÊ)Wò"»RµÙˆ‚$¬IB €{}}z3àðR´ë¤Ê/"4fº{úîžÝÍðìo_áðûòê«o~Rbf‘TήngKÄ„˜Iƒ‘atvu3{5¿mÊ·Ûr³¬ÊöbAŸW›eSm‰. óù‹p»ØØ_6//ˆ˜x(oªrÓ…G«®l6EW]P1gŸ——¯¯þþÍOÄÄÛ ×€œÛ¸Û6×õÕ?ütåaTG’õÛ¶Ç­ð8´å²*V«þnWT«º)oüà Ip±ËÏT0$”ž-A˜àV^—Ý}}sé)]ŠnKÞ—+M"¬”B”’­_ŠÍòSm13l~]-ê» x~WoŠUõ ¨7~¹buW7Uw¿ÎJ$CdXôßXà_^þó‚‰ù ¸&~õW_ú•˜¼ô·˜zð~_-ïû}Vµ%ü}ˆæ1FR¢oë^ÔÚé.®/(žoW¿ûÿê[ûkÆÇ›íºl*`ÿ÷½¥±ntW‡5ðM½)ýûõfî ;~“­#ñr8e–œU9ZU›²hM8%¦ýØvå¨x^µáwÓ é¦äÀ‰‹ ó¶^ù7=¸ÿ-ú߇‡¦þP­‹®ô/4åCS¶ îý‰Ðûû²)ý¥ÃÒ^ÀMõÁ¿cÙbï]—Ã&Dš¶ÎÐâ𷬬»{ëÝT…“'£ØÜø {Höw½ug¯Õ¼][ùmüí¶úTú«WæÒ_üYóù˨+š®ÚÜùÿn›zíWòÁ­jSuU¿õCQ5éÞžšeW7mFY&ÄmÑ—È(¦-G^aHéHÒÑ:Q¥f‹êÛÌn#IU¯Eï²›í§l&OÛl0dˆq3¸4ÀÄM ÿMFõ)âLÍ" «Ñ‚ÁXQ``ÌFÃáþ]Öë‡mWº‡tÞyMìmœù²OÓäžÜÕ¦ Kß•k= ˜­þ·)—Ûf¢,΂ÆÉ„£ ,Y}´r³Ë¦Rf°šÃƒa·Òœá.XY#'kP“pWwí!)ô]v#B…?ÊåtRöò  ÖŽâªÞ¶þŽã•¿Œ¤ÛºBIç/Â[^àÊ)ü^WÎö÷zjïm–lË®MÁƒ‡ œ-PfLª.7ÕÚZ/07» âa,zå|ŠARóË£¡Ú ™;n÷`YoÚ®Ù.A@.ýÖ÷zÑM,ÞmÝ;oFì-+“…eÛèáö}½ºiŸeˆ‘ÚÅ$ JQNã‘G®)ÍF'‰IFé8R˜Ã_BxšTB‘Vl¶ˆ ~ËlG$ÒDû±Ü~DáÜždCƒ°ÔŸ‡¾«¬3tPÓ¿xc!FtÏÚ8,IØ(bb²ÑÔ,$KÑ"!è]–7Öº&dF >‡ýeÆ€í`û]f/p BV‘l–ØAƬsp@Ï-Ðì„ÿÂWGšÔ¸3})¡Ç*/â v ÞšócFy—¦‰KëÌ#¨².Ηõ_sº¬fì3érvCŒðh~?‹2'œ—H‘á|¢ñ»œß§öQ.BDVï©ù#Ô~›å¢ÑôÿJíÙÓ¨=?Y킨ÂÄZÏp^ëG@ë­:SÐzŒ4Ðp ábªãz jÁì3 :Y鍿ˆsðú-£©›ÿö°]8°<¦4Ùíç̹Nt¢Ã¦Zƒà¤(ÀÈΡAp+¼£“èÉg¦»”P‰ ˆ |‹ r|ƒør¬ƒ|› @ ,à«ì>Œ<*]›pÔ‰êyþtF£¶o/ïEÏÙ+‘âd/'À !%S¡ŽNÔYð ’;Ë_Z7sAŒäkˆ¿1KR­H&‚×O š¬ùkN• 'fúédb_½€~™8©6ñÉ› ™q–‰&Wä$‰±¸±ÉÐc‹4¢‡æÒ:0¬úpŠJÉ‹B>Ú›»íªh•ˆZ½ 7²«m7Uç¯ÆªÿßÏYP;g±»&Óƒ=M…ˆbÖÅÐuW›§=Ëò²ß!Wì0 ý’«v„R^õsrÊ8ßÏH 1QÉ㜒#Á¸EýHÇWá±T0œ¸mÿšÈùÕ}˜…bàd9!i®š¨1R‡ë1¶ÿ¹c„ßߺq‹| ¡Ž jÃ`Êu¹,¶.ס>Θ¨~–+üãzÏÛfð/U½}W­VU±¹ÌMÐ8œ˜Ä¾¹E|bž‡Á™¨ †d<“týs %$t Ó#ƒÊk$?eîƒ98U$ /ŒGßUéŸÛ'b,~Ū­=Þ÷EßOO¥ Ì‘P|“‹PÀ}³sÝé*³•­%ðÄ›¾Éä@v)1ɦòOŽáKOéI=]±;Aš~mƒ|ÈqvdwÎÁGmš»Ü:K?Q‡á|í(‰Â$j¾Ú©7âMÀ¹Ÿ]»[ ºMí{a.ÊfÝúˇ¦~¨›.X@÷°Î0R›ƒò“[>qmbÂÕÄ« –zCÛÐýÄ#?‚²|b”;Û_©6îÜØx4ëŽÌ0½ên"5<q¹®VU&nî¢)œ0+sys@¼5#:XX[éGûéÂeÑvýœa?y é4ëg9.^ŒºLitÙ,Ëlƒubת ÜqV…„sh¬Å?[=gcøë¬—Õ±èö1UÚlgˆêÝæþ4u£cí”gB~ ±Ž )i¿¥ÙN°´‚ ®Î©}Ê®¥•8ÀÔI4Ê!.‰`ŸgÈðƒ(—yÎ[ôà×ù™$Ï$á nNèì^ìUf%;Çs®3¡ÐºNi &j-J2ç@!äþŒO رrb.Hˆ;µ=qBè‰#+gñ¢ÜÛŒyA2¼ðÝ'P"ÆãfYÙaÌWbñ>2)D@óD’Ó°ÌÌ@âçÔvÓíÈ¥­¡j¹¿xª:ZñS9žh;e§LŽ60£¹‹}Ú(“dê$mÓc|ŠVÏñyŸYJ!iÈùóÄ ¯z„áedÇz§gD²¬¢8ØqŠìq =WáG‘>ß;ûÚKÉù³±Ú“9KÆ$‚Í͘'í̘Œ‚i‘4ô³FˆÚ®Dª¯û½ÉÏã›-ÛHl×ì%ª0zñ‡«ÃrA% §\V­Ì¼È%b` }lµõmd›TBß4ÅG»o4;ˆõd]>íµÿ»˜ .\Ì¥m̵²ñžë˜Úû}@œs’iä7cÀD»~šºÀ&<?-²!ÿ ); Nµ×‡Ê4¶8ôIÛlm1áôˆô%²ýr9®ÕXÕœU^HÛ±5Eåþ†Xð ÙfR§Á`Oâæ,Ù3æP>~êÑžä„A• “öÅ5Ê FÑÔœî5”ÒºÙ„ÎXŠãŽÚŽ.pø[?k ¿÷%†C¡!?øÇæd˜'ÜVžÐ˜= …AÙÍŒôm…åöDþ‡`Â5'’‘-H#6jwÚèpf7‰1(±Šä²§.%K¼×‡“ ±£˜Å¤™±ýú¾Ûö½ ðø}–w°J^M }\„¦“rû=u&ɂӣãG›”ÐaÀûÚ@ÌŽ#˜Ç†¬°ì²ÂµY3¢‡íô:?—ø29ç™Å>GªÓ ømüð9!&^f¯ýEò¥4ÜŸŒûwÝGâÏrA‰T`“mmDäÔ¢™x¢¢Ùc>ýÙ)š±Üå‚Ë=E³Ä K’Pø´/ýOJÙn¦öY‹C…Ø©=v>ùåÞÏbò÷Ï´G@Ïre5ªâ–½‹_T&~! ,š$¨:úñê«ÿ’ɲ endstream endobj 45 0 obj << /Length 3646 /Filter /FlateDecode >> stream xÚµZKsä¶¾ûWè8ªZÑ@‚„ov¼›JÊy”£8©r|àp c9&ÈÕj}ºÑ HQ+¯jsâF£_7&½º¿J¯þøUÊßïn¿úú]‘_™Äh©¯nï®Dª•çWÚ¤‰QòêöpõóîOÝõTån\ à#UÜhÏŽ7ô7é×ìXâ°rß\˰>¯àòÃh‡®jéXxpµd9ß‹¿;œf€íyê¦úˆ50ln‹ÿìÇŲù’{ÿ»Ád‘%iYDú­JýœÂHõ M@º—Rø”æ2›÷)c >#› ãùùzìëYÅa,«À;‘\ßh¥w·4‘ºl‡Iî%+º¼]`K&²Ýññœ/Y>J¹«Z×S Ñ…SžË75'KÃj8õtòx¥ ÿn5h>4Õ}Bá'ž*hú°é$t"‹Ì[[ý»¬­~ÞKˆ4ÉÅ|µhÝg²6vÎ^ï³7þ¸±1èL™hÃב¹¿Ö¹—Æ\Û{‡üQ9ð Öî¶$ËQ[5pg¿+Vj¬uô%ÞB®Z=ò”‘¾¶ò÷ ¥ÙRc¥ñrHç@X&Gr=oK¨ 4r ñ–x¼[HM]µõÔ†E¤!‘…/œd6ƒ¿eh$wD‡LwwSW³µÆÎHå¡¶­ò2-YšWë|öœëQ€ÊWx$µî£‹ŠXÀ7’‚¦€š—†‹×I ±dä¡Óa½ÚèÈsÓ”Ê;oün“+é×8o\qèñ¦Õ<ñ¸©ªš-Ú¾i›ñ‘´u´ë´34¦9ÛÆºÕLל¦v¬:ÛOŽN.Dá¡Óó"$Á· ²È·ªóD毸© '­Å—Ñoh)—0¨,ð¬žx:gkBdX&›+‘¥ÔŸG:‚#"Áª·8*0ÍòJwCb§ÌJº¼>g©öJ¦2º9Üv:{®CÉõíÄw5ð]N,p"l!2#¬l‹g™°Ë^¡^¸äÝáíêhÐ6* {òßL™uÄ_g²¿³u59;ŠXY®ÅSì ¨Ñ,}6 0¢’÷Ñ<ت–‡À vŽ8˜’ðË…¡Ïº8©@{Mþe\Byƈ"¢6ÈeZ=S²cÓèõŒ•‹«–žëäÍ´Tj×Zç–lw°§Šív@¤ÒQ‡ºjÆ ¾Wˆ’æ«‹f!;žÎbà§¿ýþûw[G¼¬/ÁÔ¹ª­îykr€H ‰Ž"CÇä9nšÑ.V<Úe(“fe¶<2JKoû,ܼ—=…ì쨣¢Ï¦F€–¯Ã˜°"AjïYk¸¯}k¿a—|Ï8"Ü3’㌠J*–ÚæW<¨miÈžG Sæ0íÖý:ögªxÄ6Æø„è1]©S[ýL© ,;8V§tà4•£N2”å‘ ¨ü·zPqÓÞC¯š0'¬ƺ~jö©jp¤A$ ©‹ hk(ãš66~ W½m|i8y“’ïþÒÜ|°ÄZlRlÈaößýíÔ·l%yXuFWÉfÊSC1FC'ÚIÂ}±®xÝ=/{×OÝlå¶Îñ£½CÍ‚ þY¤¿$–$E<šdàˆý•H˜P@Ø÷öÃ8àÅVèôGb\¬.q>T†kà%Hà€²äíÞVzÃÇz²L²’3`·ÁÑŰ ëÁío£q“fzE²èo &4öÖ´sþúíoè½±´p—àf¶FÉ ®ºZ‡P>7‡–_ºý|×M§}K'ÕcFï& £<ÉÕJB>C‰rwA5¨" ÄVŸIóšà$‘/õWqAÆ>ƒÅ{½(pèf7†Å@¨ŸGßÂ…ú2é÷ä½÷\'¢^7#»’g"{@½Ê¥WSßb¢ó Ô3³ÊäÊ¿~g¾"W‰22«Ùf¢2•‹pc¡¢ðdæÛ Ï|^§îívXQÊòs§uà gô~øp¤[*fˆ[çªá‘ªÞš˜õíøž#\ϲþ>8qe³ªŒ@¸Ê €¹1¤àa®³t&È_ý¯Á–VAKDmÍH_ïjÑ(b·ã#ò<`ŸgJ9ÏCfaË\BWOÌl{³q•*7óËe"âÓ2q£t HÄ,Yö¬l3ïÙ»\/åp x€-8”/ˆÃ vv`së‘jï‘#U;YGuÂÛPèBàUXeá‘} ±Ç;B•ªYð»_dc xdKš$ó`mLVp—7t¨e®´ã«÷vn°9ŒG*’íy ± Y°îΘ»šNTCñ y'A¦¿Þne»¿ÿ‹ªƒ=ƒ“ wC}A¬‡-³ÎFÂw¿4E:†þàÒ~?<6õM|,l˜Õo¡8Œºõç ¸?Ášt{y:_·#^ÀŠ…üÜà©æ%›à­ç«Íé%`áØû3Ûƒ*¨Ü_#à$´TgO“ÐRšÝ»æ>!MüT%1rçÖûÕÁÞññÌÛHDl¨/Ùœ8ñÃŽ¼Š%dížvoDQy‘è4ÿRνF2€²dZÌ…ÔžÅÔ¼`€ÀØIžf+ù¥½Š&Esþ¡Q‡<_®wJ2ÈÆŠGƹͨEó[6\Р^ä±ê 2/ã¯W,+Ô„ æ5óËšwSÛ¢ø²É‘2Iu±dÊæÓ^.]–/Ztº Gu?´pb÷eĈ™ÿa넚3ΧKðlíGL GÒùb<ó{,Fm)d_ëÈâ˜ð„a ëMF0£hjÞÖ›„Â"°ðÔ¿ ü‡B©¿T¾¾LWþßáRpFý½åÀ¨yhÆãŠð~ïì@,ã“Vîñt{¸À^©$ƒ­¬\Ã/F_â³eîÙèç ¼T‰QÙË>{Wê›îÁ~ŒTñé%Øyk›"OJ!?˶ÕK©óÛŠx{äãö¼gw¬È^x 1k7 Õœî'6ñ»5[g[²˜áÈMÐ\n®Úû~€;s“î¾í¶®ði“Dw«Œ‘Ýþo µÏ5M3Ù‹mBÞ*úC£O–ùGL,í¹%ÊKÆÿø¥øíCæ1ëüGm²å+¿dCÞÞ~õ?žß¯ endstream endobj 48 0 obj << /Length 2510 /Filter /FlateDecode >> stream xÚ¥XÝsܶ×_q}£ft0@‚O_Çv2éÔQûçÇÃéP“Ä™–忾»X€GJtܦ£€],öó‡ùîaÇw¹áÏ~üç;±K¹`e©v9ϘÞÕíÍÇβ´PÊ3,Çž÷……WmÅî»ùüEÒ>ÊÜÏB¿¿¿yõVç;ÍJÍÅîþ´\±,Ïw²,ÕÙîþ¸û5yk¦ÞÜîÓT&â;ø-‹ä=Ïyÿh®“Ÿ§Öô¶®b;˜su›òä“u=®ä‰;e<Iµk/®3Ý8¼døíþo¯Þb—ƒbZyÅŠ’i•ïRV”A­vf»êŸ1Y€… ®/ĵ²R²¢(Á)ž¡êûꉎF£~ü8€H¥ª;!Sh*-žÈ¢…%§©iLo:C ?Ì'.ÔO –ªr·ðSÐÁŠo¨†lùnÁÕºÆÔSc^ƒð,KªÓhzÜ·Ûg™dJËݾdö17·ûL”‰àEbaG5Z× DðzãàÓ-ÚØLf ƃ˜ÚÇ ¶Ñph«¦a·û\(ï¡C»”«°#ë:츂QEÙsTËramª%ãåŠ÷\È Ÿ(–_ÃU» H˼Œ«l!GmË)Å,ÇRê¡’÷`b–R¬Qk0 |_æH.‡Ìg™LÉå’ù|ÈxüÊÓd¨¼aixFÓÞ¡0ðô@‹§©«c8€Û{h¹}Ž­×nêF¢t ¢TErYWD3)££•Ц57V$ª‚D6V—Kï>ÛLmžˆt®š…fh>_¥ÚÛ™ÑÖ{Èûþ|õ€E¤ò¤žàì—R‚é,]D(ÛŒPQW*NBß=…T*T%,ºãñÙŠA|ºg›ŽHÛéR*Æ3ýGÒÅŸ;Ô¶Á¬ #íx&BŽqÅÛÀ„&‚ùW´"1ÀUÄ>‹gz´5ù~/4€B^¬R(çË<õswÃäáeÓõLÑ„Ôa4¹²º’ÃôhÆÊ†±‡høÏl‹Çú\ÅyÕ›ç¾üúhO·µU=~Mv4šRÑ«ºeLàGÐêFÛMèØT‡ÎH«HÏg¿GÛ#É’ji9:´]?ËÊ0:Ìç*Ò½%ODi]²Üríl€G¯M(…¬ÏTHªnønÐå Œ3Œ?_À‹-:b4•¾šýØWÈóx¨êAÐ@¿6qe$iGg­s©ã0Þ4uQ,&!n™†¸p×ìX5ûC5„»þylL}îìGºiá †N©uÏP˜™ö'‚ëžÖ2UzÑòq‚º÷‚›Î¦µÃ؇]¾&à×Á öôD;©âÁ9tù»Cógi äÐþ¦>ÏÑ€/ 40|Ú»©9åN &ö¦¥8!u Ýg º3±ù½ P#6 ׫D3‹Ífèʃ¯‡¹Â÷B«Ì“~¾°2)WݤŒmj2\:ί„ƒÔ+ ¹v=I<X£G;*š†~ f!—±;Ú4à.¯¼(Êï¼1ÓòYÁ^G—׆¹¹»Ím>4¬vœâ#Uôê0—ãksꃿî€âuFÆ®jž¾˜°Ÿ:×"Àez”ÄRK×ý“òP¢øAéaÉߟAÅu±MHK¾ˆ Îb\°8Ê2‰€ ”õÅì—>Ù’´|žÔ<¡:"XÁàrv£Û4,Epò@éà÷žˆ€í†Òy+GÃ#³B¨Ñix¶  ºŒoX%oÁ 7€”Ã¥ªÃÜãHï3f[þ=`ö€kƒŸâ®9muxŸÀoE?!±(g‘¶ÞBDÓïæçÿ5‡Ò”©29Ôd¡‚RÊ zú—°#cJhb⩘²R@§½àÂ;3œ·d„¦SÌ%ÚÏÜ+ƒd2Ÿ¥ð„J'Ú8߯Y¾xùˆ»Ð¼Ûõ“fÑ1ûëÜÔ ºG_úd/KoÀ)ž˜{eºå0\Ð? .Bö¢=þz?œàÐ…"j±,†UNõz Lj긆ÉÐÛ®¶—&0Lä[<ø£æbÙµŽ€ ¡·ŸÁ`•ÂKàì«3÷¯È¶í{ˆØ®–áë´ Í2"å¢äÓbn'=ì"sìËù½à‰óãyBÃíéŠmE [8¤:b°J•üs %‘.Ó~œÂ‡žã{ÓJñpKqtœóŽ‚¥¤†ÌôèvžÇ¾³ÇÕ3B½Ï©)(™ ¹ãï ×?°„I˜^ í—ê`Œ¼×ï®÷ʆ![ÈïÜe­¤:tZÊ»¦g×:èä›ZŸ¡ÑÏoPÈ»%4Žz,½ú¨º€/Ž6÷!ÿÞ„B='Ùû¯ ˜’ tŽ:DÖáž„¨0'­­¯†1˜·qù™¯¼ï64™dBæ 0YçßÂu`r…ë°xe•p}+¦‹ò÷L–€—p“Äó~üõ·À_þ!ðßèÑ£3ÏŸ7ÑXðù´ð5+ Jâ<•³]é–—2–K¸/r&2ñüKûÒúBb.<þeC„%Å<`²Ì¿åñÓÿpÝ®­®Û«#WQY y½©³ÈW©ôß™ÿ¸!JC;ò™ÿBó9á¶I±¢/ÍÏÄ ó×Y°å¦œ¥\ãÅ83¾ÞJÝ”Cî®?ÙñäùË~3+™Rz}à ¾âúñþæ?Wåÿ endstream endobj 42 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (./figure1_new.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 49 0 R /BBox [0 0 582 600] /Resources << /XObject << /Im0 50 0 R >>/ProcSet [ /PDF /Text /ImageC ] >> /Length 31 >> stream q 582 0 0 600 0 0 cm /Im0 Do Q endstream endobj 50 0 obj << /Type /XObject /Subtype /Image /Name /Im0 /Filter [/RunLengthDecode] /Width 582 /Height 600 /ColorSpace 51 0 R /BitsPerComponent 8 /SMask 52 0 R /Length 53 0 R >> stream ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‹ÿ‚‚‚‚‚‚‚‚‚‚–‚ÿ‚ÿŽÿ‚‚‚‚‚‚‚‚‚‚–‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿö‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ§ÿû‚ÿ‚ÿŽÿö‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ§ÿû‚ÿ‚ÿŽÿö‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ§ÿû‚ÿ‚ÿŽÿö‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ§ÿû‚ÿ‚ÿ—ÿÿÿÿöÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ°ÿû‚ÿ‚ÿ—ÿÿÿÿöÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ°ÿû‚ÿ‚ÿŽÿö»ÿûÈÿþ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ°ÿû‚ÿ‚ÿŽÿö¾ÿþ¿ÿþ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ³ÿû‚ÿ‚ÿŽÿöÁÿþ¹ÿþ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¶ÿû‚ÿ‚ÿŽÿöÄÿû¶ÿþ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¹ÿû‚ÿ‚ÿŽÿøÂÿþ³ÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¼ÿû‚ÿ‚ÿŽÿøÅÿû°ÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¿ÿû‚ÿ‚ÿŽÿøÈÿû­ÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¿ÿû‚ÿ‚ÿŽÿøÈÿûÝÿõÚÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÂÿû‚ÿ‚ÿŽÿøËÿøàÿûûÿøàÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÂÿû‚ÿ‚ÿŽÿøËÿøæÿûòÿøãÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÅÿû‚ÿ‚ÿŽÿøËÿøæÿûòÿøãÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÅÿû‚ÿ‚ÿŽÿøËÿûãÿûòÿøãÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÅÿû‚ÿ‚ÿŽÿøÎÿøãÿûòÿøãÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÅÿû‚ÿ‚ÿŽÿøÎÿøÎÿøãÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÅÿû‚ÿ‚ÿŽÿøÎÿøÔÿòãÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÅÿû‚ÿ‚ÿŽÿøÎÿøÝÿûøÿøãÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÅÿû‚ÿ‚ÿŽÿøÎÿøàÿûõÿøãÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÅÿû‚ÿ‚ÿŽÿøÎÿøãÿûòÿøãÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÅÿû‚ÿ‚ÿŽÿøËÿøéÿøòÿøãÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÅÿû‚ÿ‚ÿŽÿøËÿøéÿøòÿøãÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÅÿû‚ÿ‚ÿŽÿøËÿøéÿøòÿøãÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÂÿû‚ÿ‚ÿŽÿøËÿøéÿõøÿòæÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÂÿû‚ÿ‚ÿŽÿøÈÿûéÿìþÿïïÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¿ÿû‚ÿ‚ÿŽÿøÈÿøéÿòøÿõìÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¿ÿû‚ÿ‚ÿŽÿøÅÿû°ÿþ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¼ÿû‚ÿ‚ÿŽÿøÂÿû¶ÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¼ÿû‚ÿ‚ÿŽÿø¿ÿþ¶ÿþ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¹ÿû‚ÿ‚ÿŽÿø¼ÿþ¿ÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¶ÿû‚ÿ‚ÿ©ÿûìÿø¹ÿþÅÿþ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ°ÿû‚ÿ‚ÿ¬ÿøìÿø¶ÿþËÿþ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ­ÿû‚ÿ‚ÿ¬ÿøìÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿ¯ÿþþÿûìÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿ²ÿþûÿûìÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿµÿþøÿûìÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿ¸ÿûøÿûìÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿ¸ÿþõÿûìÿÝ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÀÿû‚ÿ‚ÿ»ÿþòÿûìÿÝ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÀÿû‚ÿ‚ÿ¾ÿþïÿûìÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿ¾ÿþïÿûìÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿ¾ÿàòÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿ¾ÿàòÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿ©ÿûìÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿ©ÿûìÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿ©ÿûìÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿ©ÿûìÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿ²ÿøæÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿ¸ÿììÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿ»ÿþõÿøìÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿ©ÿøïÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿ¾ÿþìÿûïÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿ¾ÿþìÿûïÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿ¦ÿûïÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿ©ÿûìÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿ©ÿûìÿÝ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÀÿû‚ÿ‚ÿ©ÿþéÿÝ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÀÿû‚ÿ‚ÿ¬ÿþæÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿ¯ÿþãÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿ²ÿþàÿøûÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ°ÿû‚ÿ‚ÿµÿþÝÿøûÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ°ÿû‚ÿ‚ÿ¸ÿûÝÿøûÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ°ÿû•ÿþ‚ÿ«ÿþéÿþòÿøûÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ°ÿû˜ÿû‚ÿ«ÿæïÿöÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¼ÿû¼ÿׂÿ‚ÿýÿöÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¼ÿû¿ÿÔ‚ÿ‚ÿýÿöÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¼ÿû¿ÿÔ‚ÿ‚ÿýÿøûÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ°ÿûÂÿûÚÿþ‚ÿ‚ÿýÿøûÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ°ÿûÂÿûÚÿþ‚ÿ‚ÿýÿøûÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ°ÿû¿ÿþ‚ÿ‚ÿÓÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû¿ÿþÚÿþ‚ÿ‚ÿýÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû¼ÿþÝÿþ‚ÿ‚ÿýÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû¹ÿþàÿþ‚ÿ‚ÿýÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû¿ÿÔ‚ÿ‚ÿýÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû¿ÿÔ‚ÿ‚ÿýÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû¿ÿÔ‚ÿ‚ÿýÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû¿ÿþÚÿþ‚ÿ‚ÿýÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿüÿþÔÿû‚ÿÉÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿüÿû×ÿø‚ÿÌÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿüÿõÝÿûþÿþ‚ÿÏÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿüÿûûÿþ×ÿþ‚ÿÏÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿüÿûøÿþÚÿþ‚ÿÏÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿüÿûõÿþàÿû‚ÿÏÿøòÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¼ÿû‚ÿüÿûòÿûìÿø‚ÿÌÿøòÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¼ÿû‚ÿüÿûïÿûòÿõ‚ÿÌÿøòÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¼ÿû‚ÿüÿûéÿþõÿø‚ÿÉÿøþÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÈÿû‚ÿüÿûéÿûûÿõ‚ÿÉÿøþÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÈÿû‚ÿüÿøæÿþþÿø‚ÿÆÿøþÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÈÿû‚ÿöÿûæÿõ‚ÿÆÿøòÿÿÿýÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÈÿû‚ÿÒÿû‚ÿÃÿøòÿÿÿýÿÿÿýÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÑÿû‚ÿÏÿû‚ÿÆÿøòÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÑÿû‚ÿÌÿþ‚ÿÆÿøòÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÑÿû‚ÿ‚ÿŽÿøòÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÑÿû‚ÿ‚ÿŽÿøæÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÝÿû‚ÿ‚ÿŽÿøæÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÝÿû‚ÿ‚ÿŽÿøæÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÝÿû‚ÿ‚ÿŽÿøæÿÿÿýÿÿúÿÿýÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿéÿû‚ÿ‚ÿŽÿøÚÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿéÿû‚ÿ‚ÿŽÿøÚÿÿÿÿÿÿÿÿÿÿýÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿòÿû‚ÿ‚ÿŽÿøÚÿÿÿÿÿÿÿÿÿÿýÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿòÿû‚ÿ‚ÿŽÿøÑÿÿÿÿÿÿÿÿÿÿýÿÿÿýÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿˆÿû‚ÿ‚ÿŽÿøÑÿÿÿÿÿÿÿÿÿÿýÿÿÿýÿÿúÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ”ÿû‚ÿ‚ÿŽÿøÎÿÿýÿÿÿÿÿÿÿÿÿÿýÿÿúÿÿýÿÿÿýÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿû‚ÿ‚ÿŽÿøÅÿ(ÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿýÿÿÿýÿÿÿýÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿµÿû‚ÿ‚ÿŽÿøÅÿ1ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿÿýÿÿÿýÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿµÿû‚ÿ‚ÿŽÿøÅÿIÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿýÿÿÿýÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÊÿû‚ÿ‚ÿŽÿø¹ÿÿýÿ=ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿÿýÿÿúÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÖÿû‚ÿ‚ÿŽÿø¹ÿÿýÿÿÿýÿÿúÿ1ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿúÿÿýÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿâÿû‚ÿ‚ÿŽÿø¹ÿÿýÿÿÿýÿÿúÿÿýÿ4ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿýÿÿÿýÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿëÿû‚ÿ‚ÿŽÿø°ÿÿÿýÿÿúÿÿýÿÿÿýÿ1ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿÿýÿÿúÿÿýÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ„ÿû‚ÿ‚ÿŽÿø¤ÿÿúÿÿýÿÿÿýÿ=ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿúÿÿýÿÿÿýÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿû‚ÿ‚ÿ²ÿõéÿøÿÿÿýÿÿÿýÿÿýÿ=ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿÿýÿÿýÿÿÿýÿÿÿýÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ®ÿû‚ÿ‚ÿ¸ÿûøÿûìÿøƒÿÿÿýÿÿýÿÿÿýÿÿýÿ4ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿýÿÿÿýÿÿÿýÿÿýÿÿÿýÿÿÿýÿÿýÿÿÿýÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿçÿû‚ÿ‚ÿ¸ÿûõÿûïÿø‚ÿöÿÿýÿÿÿýÿÿúÿÿýÿ1ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿÿýÿÿÿýÿÿýÿÿÿýÿÿÿýÿÿýÿÿÿýÿÿÿýÿÿýÿÿÿýÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ×ÿÿÿýÿÿúÿÿýÿÿÿýÿÿÿýÿÿýÿÿÿýÿÿ‚ÿ‚ÿ‡ÿû‚ÿ‚ÿ»ÿûòÿûïÿø‚ÿíÿÿÿýÿÿúÿÿýÿÿÿýÿ1ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿÿýÿÿýÿÿÿýÿÿÿýÿÿýÿÿÿýÿÿÿýÿÿýÿÿÿýÿÿÿýÿÿýÿÿÿýÿÿÿîÿÿÿýÿÿúÿÿýÿÿÿýÿÿýÿÿÿýÿÿúÿÿúÿÿýÿÿÿýÿÿýÿÿÿýÿÿúÿÿýÿÿÿýÿÿÿýÿÿýÿÿÿýÿÿýÿÿÿýÿÿÿýÿÿúÿÿýÿÿÿýÿÿâÿÿÿýÿÿÿýÿÿÿýÿÿýÿÿÿýÿÿýÿÿÿýÿÿÿýÿÿúÿÿýÿÿÿýÿÿýÿÿÿýÿÿúÿÿúÿÿýÿÿÿýÿÿýÿÿÿýÿÿúÿÿýÿÿÿýÿÿÿýÿÿýÿÿÿýÿÿýÿÿÿýÿÿÿýÿÿÿýÿÿýÿÿÿýÿÿýÿÿÿýÿÿÿýÿÿÿýÿÿýÿÿÿýÿÿýÿÿÿýÿÿÿ‚ÿÈÿÿÿýÿÿýÿÿÿýÿÿû‚ÿ‚ÿ»ÿûïÿûòÿö~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿYÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿû‚ÿ‚ÿ¾ÿøïÿûòÿö~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿYÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿû‚ÿ‚ÿ¾ÿûìÿûòÿö~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿYÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿû‚ÿ‚ÿ¾ÿûìÿûòÿö~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿYÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿùÿÿ‚ÿ‚ÿÆÿûìÿûþÿ ÿÿÿÿÛ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ>ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿùÿÿÿ‚ÿ‚ÿÉÿûìÿûþÿ ÿÿÿÿÛ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ>ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿùÿÿÿ‚ÿ‚ÿÉÿûìÿûòÿö~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿYÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿû‚ÿ‚ÿ¾ÿûìÿûòÿö~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿYÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿû‚ÿ‚ÿ¾ÿøïÿûòÿö~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿYÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿû‚ÿ‚ÿ»ÿûïÿûòÿö~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿYÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿû‚ÿ‚ÿ»ÿûòÿûïÿø‚ÿðÿÿýÿÿÿýÿÿýÿÿÿýÿ=ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿýÿÿÿýÿÿÿýÿÿÿýÿÿýÿÿÿýÿÿýÿÿÿýÿÿÿýÿÿÿýÿÿÊÿÿýÿÿÿýÿÿúÿÿýÿÿÿýÿÿýÿÿÿýÿÿÿýÿÿúÿÿýÿÿÿýÿÿýÿÿÿýÿÿÿýÿÿýÿÿÿýÿÿÿýÿÿýÿÿÿýÿÿúÿÿ‚ÿÑÿÿúÿÿýÿÿÿýÿÿúÿÿýÿÿÿýÿÿúÿÿýÿÿÿýÿÿúÿÿýÿÿÿýÿÿýÿÿÿýÿÿÿýÿÿýÿÿÿýÿÿÿýÿÿýÿÿÿýÿÿÿýÿÿýÿÿÿ‚ÿ‚ÿÛÿû‚ÿ‚ÿ»ÿøõÿûïÿø‚ÿüÿÿúÿÿýÿÿÿýÿÿýÿ4ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿýÿÿÿýÿÿýÿÿÿýÿÿÿýÿÿÿýÿÿýÿÿÿýÿÿýÿÿÿýÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿËÿÿÿýÿÿúÿÿýÿÿÿýÿÿýÿÿÿýÿÿÿ‚ÿ‚ÿ„ÿû‚ÿ‚ÿ¸ÿûøÿûìÿø‰ÿÿúÿÿúÿÿýÿ=ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿÿýÿÿýÿÿÿýÿÿýÿÿÿýÿÿÿýÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÌÿû‚ÿ‚ÿ²ÿøæÿø•ÿÿÿýÿÿúÿÿýÿ4ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿýÿÿÿýÿÿÿýÿÿýÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿŸÿû‚ÿ‚ÿŽÿøªÿÿÿýÿÿýÿÿÿýÿÿúÿ1ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿúÿÿýÿÿÿýÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿŠÿû‚ÿ‚ÿŽÿø³ÿÿýÿÿÿýÿÿýÿÿÿýÿ=ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿúÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿñÿû‚ÿ‚ÿŽÿø³ÿÿýÿÿÿýÿÿýÿ4ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿýÿÿÿýÿÿúÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿñÿû‚ÿ‚ÿŽÿø¿ÿÿúÿÿýÿ=ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿÿýÿÿýÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÜÿû‚ÿ‚ÿŽÿø¿ÿÿýÿ=ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿúÿÿýÿÿÿýÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÐÿû‚ÿ‚ÿŽÿøËÿÿÿýÿ1ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿúÿÿúÿÿýÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿû‚ÿ‚ÿŽÿøËÿÿÿýÿ1ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿúÿÿúÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ»ÿû‚ÿ‚ÿŽÿøËÿ(ÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿýÿÿÿýÿÿúÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿû‚ÿ‚ÿŽÿøËÿÿÿÿÿÿÿÿÿÿýÿÿÿýÿÿýÿÿÿýÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ£ÿû‚ÿ‚ÿŽÿø×ÿÿÿÿÿÿÿÿÿÿúÿÿýÿÿÿýÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿŽÿû‚ÿ‚ÿŽÿø×ÿÿÿÿÿÿÿÿÿÿúÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿøÿû‚ÿ‚ÿŽÿø×ÿÿÿÿÿÿÿÿÿÿúÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿøÿû‚ÿ‚ÿŽÿø×ÿÿÿýÿÿÿýÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿìÿû‚ÿ‚ÿŽÿøàÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿãÿû‚ÿ‚ÿŽÿøàÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿãÿû‚ÿ‚ÿŽÿøàÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿãÿû‚ÿ‚ÿŽÿøìÿÿÿýÿÿýÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ×ÿû‚ÿ‚ÿŽÿøìÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ×ÿû‚ÿ‚ÿŽÿøìÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ×ÿû‚ÿ‚ÿŽÿøøÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÎÿû‚ÿ‚ÿŽÿøøÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÎÿû‚ÿ‚ÿŽÿøøÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÎÿû‚ÿ‚ÿŽÿøìÿÿÿýÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿËÿû‚ÿ‚ÿŽÿøìÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÂÿû‚ÿ‚ÿŽÿøìÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÂÿû‚ÿ‚ÿŽÿøìÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÂÿû‚ÿ‚ÿŽÿøõÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¶ÿû‚ÿ‚ÿŽÿøõÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¶ÿû‚ÿ‚ÿŽÿøõÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¶ÿû‚ÿ‚ÿŽÿøõÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¶ÿû‚ÿ‚ÿŽÿöÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÂÿû‚ÿ‚ÿŽÿöÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÂÿû‚ÿ‚ÿŽÿøõÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¶ÿû‚ÿ‚ÿŽÿøõÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¶ÿû‚ÿ‚ÿŽÿøõÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¶ÿû‚ÿ‚ÿŽÿøõÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¶ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿµÿõæÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿ¸ÿììÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿ»ÿþòÿøïÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿ©ÿøïÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿ¾ÿþìÿûïÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿ¦ÿûïÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿ¦ÿûïÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿ©ÿûìÿÝ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÀÿû‚ÿ‚ÿ©ÿûìÿÝ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÀÿû‚ÿ‚ÿ¬ÿûéÿÝ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÀÿû‚ÿ‚ÿ¬ÿþæÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿÖÿïìÿþãÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿ²ÿþàÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿµÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿ¸ÿþìÿþòÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿ»ÿæïÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿ¾ÿãïÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿöÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ­ÿû‚ÿ‚ÿŽÿöÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ­ÿû‚ÿ‚ÿŽÿöÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ­ÿû‚ÿ‚ÿŽÿöÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ­ÿû‚ÿ‚ÿ‘ÿÿöÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¶ÿû‚ÿ‚ÿ‘ÿÿöÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¶ÿû‚ÿ‚ÿŽÿöÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ­ÿû‚ÿ‚ÿŽÿöÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ­ÿû‚ÿ‚ÿŽÿ‚‚‚‚‚‚‚‚‚‚–‚ÿ‚ÿŽÿ‚‚‚‚‚‚‚‚‚‚–‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø¶ÿþòÿûÚÿþ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ³ÿû‚ÿ‚ÿŽÿø¹ÿûûÿò×ÿþ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¶ÿû‚ÿ‚ÿŽÿø¼ÿþïÿøÔÿþ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¹ÿû‚ÿ‚ÿŽÿø¿ÿþìÿøÑÿþ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¼ÿû‚ÿ‚ÿŽÿøÂÿþéÿøÎÿþ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¿ÿû‚ÿ‚ÿŽÿøÅÿûéÿøÎÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÂÿû‚ÿ‚ÿŽÿøÈÿøéÿøËÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿŠÿþÝÿû‚ÿêÿû‚ÿ‚ÿŽÿøÈÿûæÿøËÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ“ÿõãÿõ‚ÿêÿû‚ÿ‚ÿŽÿøËÿøæÿøûÿòàÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿûàÿø‚ÿêÿû‚ÿ‚ÿŽÿøËÿøæÿÝãÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿûàÿø‚ÿêÿû‚ÿ‚ÿŽÿøËÿøæÿòûÿòãÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿîÿ‚ÿüÿûàÿø‚ÿêÿû‚ÿ‚ÿŽÿøËÿûãÿøïÿõæÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ²ÿÿÿôÿÿÿ‚ÿÿÿûàÿø‚ÿêÿû‚ÿ‚ÿŽÿøËÿûãÿøìÿõéÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ²ÿ ÿÿÿúÿ ÿÿÿ¹ÿòæÿõþÿûïÿõþÿøÝÿûûÿø¤ÿû‚ÿ‚ÿŽÿøÎÿøãÿøìÿõéÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿÿÿÿÿÿÿÿ¼ÿûõÿûïÿûõÿøòÿûõÿøæÿïûÿø§ÿû‚ÿ‚ÿŽÿøÎÿøãÿøéÿøéÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿÿÿÿÿÿ¼ÿûïÿûõÿûïÿûõÿûòÿøàÿøõÿøªÿû‚ÿ‚ÿŽÿøÎÿøãÿøéÿøéÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ©ÿ ÿÿÿ¹ÿûïÿøøÿûïÿûøÿøòÿøàÿøõÿøªÿû‚ÿ‚ÿŽÿøÎÿøãÿøéÿøéÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿÿÿÿÿÿ¿ÿøïÿøûÿøïÿûøÿûïÿøàÿøõÿøªÿû‚ÿ‚ÿŽÿøÎÿøãÿøéÿøéÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿÿÿÿÿÿÿÿÂÿøìÿûûÿøïÿûøÿûïÿøàÿøõÿøªÿû‚ÿ‚ÿŽÿøËÿûãÿøéÿøéÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ²ÿ ÿÿÿúÿ ÿÿÿÅÿøìÿûûÿøïÿûøÿûïÿøàÿøõÿøªÿû‚ÿ‚ÿŽÿøËÿøæÿøéÿûæÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ²ÿÿÿôÿÿÿÅÿøìÿûûÿøïÿûøÿûïÿøàÿøõÿøªÿû‚ÿ‚ÿŽÿøËÿøæÿøéÿûæÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿîÿÂÿøìÿûûÿøïÿûøÿøòÿøàÿøõÿøªÿû‚ÿ‚ÿŽÿøúÿÿñÿÿÿïÿøæÿøìÿûæÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÒÿûïÿøûÿøïÿûøÿøòÿøàÿøõÿøªÿû‚ÿ‚ÿŽÿøýÿ ÿÿÿ÷ÿ ÿÿÿìÿûæÿøïÿûãÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÒÿøòÿûõÿøòÿûøÿøòÿøàÿøõÿøªÿû‚ÿ‚ÿŽÿø÷ÿÿÿýÿ ÿÿÿéÿûãÿéÝÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÌÿûòÿþïÿøûÿïûÿõûÿïæÿøõÿøªÿû‚ÿ‚ÿŽÿø÷ÿÿÿÿÿÿÿãÿûÝÿø×ÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÉÿûøÿþìÿïþÿøõÿæãÿõõÿõ­ÿû‚ÿ‚ÿŽÿøôÿ ÿÿÿÿÝÿþ­ÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÂÿû‚ÿ‚ÿŽÿøôÿ ÿÿÿÿÝÿû³ÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¿ÿû‚ÿ‚ÿŽÿø÷ÿÿÿÿÿÿÿÝÿû¶ÿþ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¼ÿû‚ÿ‚ÿŽÿøúÿ ÿÿÿýÿ ÿÿÿÝÿþ¹ÿþ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¹ÿû‚ÿ‚ÿŽÿøýÿ ÿÿÿ÷ÿ ÿÿÿÝÿûÂÿþ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¶ÿû‚ÿ‚ÿŽÿø÷ÿñÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÆÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ©ÿòõÿïøÿõòÿõìÿûûÿø×ÿþøÿøÅÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿÿÿ³ÿþõÿûõÿøïÿþòÿþõÿøûÿïûÿøãÿõþÿþûÿøÈÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿÿÿ¶ÿûõÿøõÿûïÿþòÿþòÿûõÿøõÿûÝÿøõÿûÈÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿÿÿ¶ÿþïÿûõÿøòÿþõÿþïÿûõÿøõÿøàÿûòÿøËÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿÿÿ¹ÿãòÿûõÿþòÿãøÿøõÿøàÿûòÿøËÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿÿÿ¹ÿûÚÿøøÿþõÿûÝÿøõÿøàÿûòÿøËÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿ#ÿÿÿÿÿÿÿÿÿÿÿÿÈÿû×ÿûøÿþõÿûÝÿøõÿøàÿûòÿøËÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿ#ÿÿÿÿÿÿÿÿÿÿÿÿÈÿû×ÿûûÿþòÿûÝÿøõÿøàÿûòÿøËÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿÿÿ¹ÿøìÿþïÿûþÿþòÿøàÿøõÿøàÿûòÿøËÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿÿÿ¹ÿøìÿþïÿõïÿûìÿþøÿøõÿøàÿûòÿøËÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿÿÿ¶ÿøòÿþìÿøìÿøòÿþõÿøõÿøàÿûòÿøËÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿÿÿ¶ÿõøÿþæÿûìÿõøÿûõÿøõÿøàÿûòÿøËÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿÿÿ³ÿïãÿþæÿìõÿõøÿõãÿõøÿõËÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿÉÿÿôÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ÷ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿÌÿ ÿÿÿúÿ ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ÷ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿÉÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿôÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿÆÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿôÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿÃÿ ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿÆÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿñÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿÉÿÿÿÿÿÿÿÿµÿîÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿØÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿÛÿÿôÿ ÿÿÿýÿ ÿÿÿ»ÿÿÿôÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÛÿû‚ÿ‚ÿŽÿøÜÿîÿ‚ÿžÿ ÿÿÿÿúÿ ÿÿÿÿúÿÿÿ»ÿ ÿÿÿúÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿáÿû‚ÿ‚ÿŽÿøßÿÿÿôÿÿÿ‚ÿ¡ÿÿÿÿÿÿÿÿÿÿÿôÿÿÿ»ÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿÎÿ‚ÿ‚ÿ—ÿû‚ÿ‚ÿŽÿøßÿ ÿÿÿúÿ ÿÿÿ‚ÿžÿ"ÿÿÿÿÿÿÿÿÿÿÿ÷ÿÿÿ¸ÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿÎÿÿÿôÿÿÿ‚ÿ‚ÿ¯ÿû‚ÿ‚ÿŽÿøÜÿÿÿÿÿÿÿ‚ÿžÿúÿ.ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÁÿ÷ÿÿÿÿÿÿÿÿÿÿôÿ‚ÿ‚ÿ‚ÿ‚ÿìÿÿýÿ ÿÿÿýÿ ÿÿÿÿñÿÿ‚ÿ‚ÿÄÿû‚ÿ‚ÿŽÿøÙÿÿÿÿÿÿ‚ÿ¡ÿÿÿúÿ+ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÄÿÿÿýÿ"ÿÿÿÿÿÿÿÿÿÿÿúÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿïÿÿÿýÿÿÿÿÿÿÿÿÿÿ÷ÿ ÿÿÿ‚ÿ‚ÿÇÿû‚ÿ‚ÿŽÿøÖÿ ÿÿÿ‚ÿžÿ7ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿÿÿÿÿÖÿ+ÿÿÿÿÿÿÿÿÿÿÿÿÿÿúÿ ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿïÿ ÿÿÿýÿÿÿÿÿÿÿÿÿÿýÿ ÿÿÿ‚ÿ‚ÿÄÿû‚ÿ‚ÿŽÿøÙÿÿÿÿÿÿ‚ÿžÿLÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÖÿ7ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿéÿ4ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿÁÿû‚ÿ‚ÿŽÿøÜÿÿÿýÿ ÿÿÿ‚ÿžÿFÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿâÿúÿúÿ7ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿñÿÿ‚ÿ‚ÿ‚ÿ‚ÿþÿ.ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ¾ÿû‚ÿ‚ÿŽÿøßÿ ÿÿÿúÿ ÿÿÿ‚ÿ¡ÿCÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿâÿÿúÿÿýÿ.ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿÿôÿÿ‚ÿ‚ÿ‚ÿ‚ÿûÿ+ÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ¾ÿû‚ÿ‚ÿŽÿøßÿÿÿôÿÿÿ‚ÿ¡ÿ%ÿÿÿÿÿÿÿÿÿÿÿÿýÿÿÿÿÿÿÿÿâÿXÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿ ÿÿÿÿ‚ÿ‚ÿ‚ÿ‘ÿÿúÿ1ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿÁÿû‚ÿ‚ÿŽÿøÜÿîÿ‚ÿ§ÿýÿCÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÜÿdÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿšÿúÿ@ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿôÿÿñÿÿ‚ÿ‚ÿëÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿíÿÿÿÿÿÿýÿÿÿÿÿÿúÿ"ÿÿÿÿÿÿÿÿÿÿÿëÿôÿ^ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿšÿ ÿÿÿýÿ@ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿúÿ ÿÿÿ÷ÿ ÿÿÿ‚ÿ‚ÿîÿû‚ÿ‚ÿŽÿøåÿÿÿñÿ‚ÿ¤ÿ ÿÿÿÿýÿÿÿÿÿÿ÷ÿ%ÿÿÿÿÿÿÿÿÿÿÿÿñÿÿÿôÿÿÿÿÿÿÿýÿ ÿÿÿýÿ1ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ”ÿ ÿÿÿýÿÿÿÿÿÿýÿ%ÿÿÿÿÿÿÿÿÿÿÿÿôÿ ÿÿÿýÿ ÿÿÿ‚ÿ‚ÿëÿû‚ÿ‚ÿŽÿøåÿÿÿôÿÿÿ‚ÿ¤ÿÿÿÿÿÿÿÿýÿÿúÿ+ÿÿÿÿÿÿÿÿÿÿÿÿÿÿôÿ ÿÿÿúÿÿÿÿÿÿÿÿÿúÿ÷ÿ.ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿîÿ‚ÿ‚ÿ‚ÿ©ÿÿÿÿÿÿÿÿÿÿ÷ÿÿÿÿÿÿýÿ ÿÿÿîÿÿÿÿÿÿÿ‚ÿ‚ÿèÿû‚ÿ‚ÿŽÿøåÿ ÿÿÿúÿ ÿÿÿ‚ÿ¡ÿÿÿÿÿÿèÿ ÿÿÿÿúÿÿÿÿÿÿ÷ÿýÿ+ÿÿÿÿÿÿÿÿÿÿÿÿÿÿñÿ1ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿôÿÿÿ‚ÿ‚ÿ‚ÿ©ÿÿÿÿÿÿÿÿÿ÷ÿÿÿÿÿÿÿÿÿÿÿëÿ ÿÿÿÿ‚ÿ‚ÿåÿû‚ÿ‚ÿŽÿøâÿÿÿÿÿÿÿÿ‚ÿ›ÿ ÿÿÿÖÿÿôÿÿÿýÿÿÿýÿ+ÿÿÿÿÿÿÿÿÿÿÿÿÿÿ÷ÿ7ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿúÿ ÿÿÿ‚ÿ°ÿÿñÿÿ‹ÿŽÿ+ÿÿÿÿÿÿÿÿÿÿÿÿÿÿúÿ ÿÿÿÿèÿ ÿÿÿÿ‚ÿ‚ÿåÿû‚ÿ‚ÿŽÿøÜÿ ÿÿÿÿ‚ÿÚÿîÿÙÿÿÿÿÿÿÜÿ ÿÿÿúÿ ÿÿÿýÿ ÿÿÿýÿÿÿÿÿÿÿýÿÿÿÿÿÿúÿ ÿÿÿýÿ:ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ°ÿ ÿÿÿ÷ÿ ÿÿÿ‘ÿÿÿôÿÿ£ÿ(ÿÿÿÿÿÿÿÿÿÿÿÿÿôÿÿÿèÿÿÿÿÿÿÿýÿÿñÿÿôÿÿñÿÿ‚ÿ®ÿû‚ÿ‚ÿŽÿøÜÿ ÿÿÿ‚ÿÚÿÿÿôÿÿÿÜÿÿÿÿÿÿÿÜÿ ÿÿÿýÿ ÿÿÿúÿ(ÿÿÿÿÿÿÿÿÿÿÿÿÿúÿÿÿÿÿÿÿúÿ7ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿªÿ ÿÿÿýÿ ÿÿÿ‘ÿ ÿÿÿ÷ÿ ÿÿÿ©ÿ(ÿÿÿÿÿÿÿÿÿÿÿÿÿñÿÿÿôÿ÷ÿÿÿÿÿÿÿÿÿÿÿ÷ÿ ÿÿÿúÿ ÿÿÿ÷ÿÿÿ‚ÿ®ÿû‚ÿ‚ÿŽÿøßÿÿÿÿÿÿ‚ÿÝÿ ÿÿÿúÿ ÿÿÿâÿ ÿÿÿúÿ ÿÿÿÜÿÿÿÿÿÿÿôÿ"ÿÿÿÿÿÿÿÿÿÿÿýÿÿýÿ ÿÿÿÿ÷ÿ ÿÿÿúÿ"ÿÿÿÿÿÿÿÿÿÿÿ‚ÿ¤ÿÿÿÿÿÿÿ‹ÿ ÿÿÿýÿ ÿÿÿ²ÿúÿÿÿÿÿÿÿÿÿÿýÿÿîÿîÿ1ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿÿÿÿÿúÿ ÿÿÿýÿ ÿÿÿ‚ÿ®ÿû‚ÿ‚ÿÓÿþÚÿøïÿøâÿÿÿÿÿÿÿÿ‚ÿéÿÿúÿÿÿÿÿÿÿÿßÿÿÿôÿÿÿÙÿ ÿÿÿ÷ÿúÿÿÿÿÿÿÿÿÿÿÿýÿ ÿÿÿýÿ ÿÿÿúÿÿÿÿÿÿúÿ"ÿÿÿÿÿÿÿÿÿÿÿñÿÿ‚ÿ¹ÿ ÿÿÿÿ‚ÿÿÿÿÿÿ²ÿÿÿÿÿÿÿýÿÿÿÿÿÿýÿÿÿôÿ ÿÿÿôÿIÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿúÿÿÿÿÿÿÿ‚ÿ«ÿû‚ÿ‚ÿÙÿøàÿûæÿøåÿ ÿÿÿúÿ ÿÿÿ‚ÿïÿ ÿÿÿúÿÿÿÿÿÿßÿýÿîÿÙÿÿÿÿÿÿýÿ(ÿÿÿÿÿÿÿÿÿÿÿÿÿýÿ ÿÿÿ÷ÿÿÿÿÿÿÿýÿÿÿÿÿÿÿÿÿýÿÿÿÿÿÿÿÿ÷ÿ ÿÿÿ‚ÿ¼ÿ ÿÿÿÿ‚ÿþÿ ÿÿÿ¬ÿ%ÿÿÿÿÿÿÿÿÿÿÿÿýÿ ÿÿÿúÿ ÿÿÿÿýÿýÿ(ÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿÿÿÿÿÿÿÿÿôÿ ÿÿÿÿ‚ÿ¨ÿû‚ÿ‚ÿßÿþûÿûãÿûãÿøåÿÿÿñÿ‚ÿéÿ ÿÿÿýÿ ÿÿÿÿßÿ ÿÿÿ÷ÿÿÿÙÿLÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿñÿÿÿÿÿÿúÿ4ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿ ÿÿÿ‚ÿ¼ÿÿÿÿÿÿÿ…ÿÿÿÿÿÿôÿñÿÿÐÿ%ÿÿÿÿÿÿÿÿÿÿÿÿúÿ:ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿ+ÿÿÿÿÿÿÿÿÿÿÿÿÿÿñÿ ÿÿÿÿ‚ÿïÿÿñÿÿÔÿû‚ÿ‚ÿÖÿûæÿûàÿøâÿîÿ‚ÿæÿÿÿÿÿÿÿÿÿÿâÿ ÿÿÿ÷ÿ ÿÿÿÜÿ(ÿÿÿÿÿÿÿÿÿÿÿÿÿúÿÿÿÿÿÿÿÿÿëÿÿÿÿÿÿúÿ=ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ¼ÿ ÿÿÿýÿ ÿÿÿ‹ÿÿÿÿÿÿÿ÷ÿÿÿ÷ÿ ÿÿÿ÷ÿÿâÿÿÿÿÿÿÿÿúÿ ÿÿÿýÿgÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿñÿÿÿÿÿÿÿ‚ÿõÿÿÿôÿ ÿÿÿ×ÿû‚ÿ‚ÿÖÿûéÿûÝÿø‚ÿ­ÿÿÿÿÿÿÿÿÿÿâÿ ÿÿÿýÿ ÿÿÿÜÿÿÿúÿÿÿÿÿÿÿÿÿúÿÿÿÿÿÿÿÿÿÿîÿUÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ¼ÿ ÿÿÿ÷ÿ ÿÿÿ—ÿÿÿÿÿÿýÿ ÿÿÿúÿ ÿÿÿýÿ ÿÿÿÿúÿ ÿÿÿåÿÿÿÿÿÿÿýÿÿÿÿÿÿúÿ ÿÿÿúÿRÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿôÿ ÿÿÿýÿ ÿÿÿ¬ÿîÿåÿ ÿÿÿúÿ ÿÿÿ÷ÿÿîÿøÿû‚ÿ‚ÿÖÿûìÿøÝÿø‚ÿ­ÿ ÿÿÿÿúÿ ÿÿÿâÿÿÿÿÿÿÿÖÿ÷ÿÿÿÿÿÿÿÿýÿ%ÿÿÿÿÿÿÿÿÿÿÿÿ÷ÿ ÿÿÿýÿRÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿñÿÿ‚ÿãÿôÿÿÿ÷ÿÿÿôÿ¦ÿÿÿÿÿÿýÿÿÿÿÿÿýÿÿÿÿÿÿÿÿÿÿýÿ ÿÿÿâÿ%ÿÿÿÿÿÿÿÿÿÿÿÿúÿÿÿÿÿÿ÷ÿ%ÿÿÿÿÿÿÿÿÿÿÿÿýÿ%ÿÿÿÿÿÿÿÿÿÿÿÿúÿ ÿÿÿÿúÿÿÿ¯ÿÿÿôÿÿÿâÿÿÿÿÿÿÿ÷ÿ ÿÿÿôÿÿÿûÿû‚ÿ‚ÿÖÿûìÿøþÿøéÿøÙÿÿñÿÿÄÿÿîÿÓÿÿýÿÿÿÿÿÿÿúÿÿÿÜÿÿÿÊÿ+ÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿÿÿÿÿÿÿÿýÿ ÿÿÿ÷ÿÿÿÿÿÿÿýÿ ÿÿÿúÿ(ÿÿÿÿÿÿÿÿÿÿÿÿÿ÷ÿ ÿÿÿ‚ÿïÿ ÿÿÿÿúÿ ÿÿÿÿýÿÿÿôÿÿÿ¬ÿUÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿâÿÿÿÿÿÿÿÿÿÿúÿ@ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿFÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ÷ÿ ÿÿÿµÿ ÿÿÿúÿÿÿÜÿ ÿÿÿÿ÷ÿÿÿÿÿÿýÿ ÿÿÿøÿû‚ÿ‚ÿÖÿûìÿûþÿòìÿøÙÿÿôÿ ÿÿÿÇÿÿÿôÿÿÿÖÿÿÿÿÿÿÿÿÿÿÿúÿÜÿ ÿÿÿÿÍÿXÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿôÿÿÿÿÿÿýÿ ÿÿÿÿýÿ:ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿìÿ ÿÿÿÿúÿÿÿÿÿÿÿÿÿÿúÿ ÿÿÿ©ÿÿÿÿÿÿÿÿÿÿÿýÿ+ÿÿÿÿÿÿÿÿÿÿÿÿÿÿîÿôÿÿÿÿÿÿÿÿÿÿúÿÿÿÿÿÿúÿ(ÿÿÿÿÿÿÿÿÿÿÿÿÿýÿFÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿôÿÿÿ²ÿÿÿÿÿÿÿÿÜÿ ÿÿÿÿúÿ"ÿÿÿÿÿÿÿÿÿÿÿøÿûÿ‚ÿ‚ÿÙÿûïÿøõÿøïÿÝôÿ ÿÿÿýÿ ÿÿÿÄÿ ÿÿÿúÿÿÿÙÿ(ÿÿÿÿÿÿÿÿÿÿÿÿÿôÿÿôÿÿýÿÿÿÿÿÿÿÓÿ(ÿÿÿÿÿÿÿÿÿÿÿÿÿ÷ÿÿñÿÿúÿÿôÿÿÿÿÿÿÿÿýÿÿÿ÷ÿ4ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿéÿ@ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ÷ÿ¸ÿúÿLÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿñÿ ÿÿÿúÿÿÿÿÿÿÿÿÿôÿ ÿÿÿôÿ(ÿÿÿÿÿÿÿÿÿÿÿÿÿýÿIÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿ ÿÿÿ¯ÿÿÿÿÿÿîÿÿÿ÷ÿÿÿÿÿÿÿÿÿÿÿúÿÿÿÿÿÿÿÿÿþÿûÿÿ‚ÿ‚ÿÜÿûïÿûïÿøòÿÝñÿÿÿÿÿÿÿÇÿÿÿÿÿÿÿÿÿÿÙÿ+ÿÿÿÿÿÿÿÿÿÿÿÿÿÿ÷ÿ ÿÿÿúÿ"ÿÿÿÿÿÿÿÿÿÿÿÖÿ ÿÿÿÿýÿÿÿÿÿÿÿÿÿÊÿ ÿÿÿúÿ ÿÿÿîÿ1ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿîÿ‚ÿøÿ:ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿúÿ ÿÿÿ¾ÿÿÿúÿLÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿÿýÿ(ÿÿÿÿÿÿÿÿÿÿÿÿÿôÿ ÿÿÿÿ÷ÿgÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿúÿÿÿÿÿÿÿ©ÿ ÿÿÿîÿ ÿÿÿÿýÿÿÿÿÿÿÿÿÿÿÿúÿÿÿÿÿÿÿÿÿÿÿùÿ‚ÿ‚ÿÙÿûïÿûìÿûòÿøÓÿ ÿÿÿÿÄÿÿÿÿÿÿÿÿÿÿÖÿÿÿÿÿÿÿÿÿúÿ ÿÿÿýÿ ÿÿÿôÿÿÿÿÿÿÿÿÿÿÿÐÿÿ÷ÿÿÿÿÿÿÿÿÿÍÿÿÿôÿÿÿñÿ7ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿÿÿÿÿ‚ÿõÿ4ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿ ÿÿÿ»ÿ ÿÿÿýÿ[ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿ(ÿÿÿÿÿÿÿÿÿÿÿÿÿúÿÿÿýÿÿÿ÷ÿÿÿÿÿÿúÿOÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿúÿ ÿÿÿÿ©ÿÿÿÿÿÿýÿÿúÿ1ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿ ÿÿÿÿÿÿÿÿÿÿÿùýÿ‚ÿ‚ÿÜÿûïÿûìÿûòÿøÓÿ ÿÿÿÿÁÿÿÿÿÿÿÿÿÍÿÿÿÿÿÿÿýÿýÿÿÿÿÿÿÿýÿÿ÷ÿÿÿÿÿÿÿ¾ÿ"ÿÿÿÿÿÿÿÿÿÿÿÍÿîÿñÿ ÿÿÿÿúÿ7ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿõÿCÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ»ÿmÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿ4ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ÷ÿ ÿÿÿñÿôÿýÿ[ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ¯ÿ"ÿÿÿÿÿÿÿÿÿÿÿúÿSÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿùÿÿÿ‚ÿ‚ÿßÿûìÿþìÿûòÿøÓÿÿÿÿÿÿÁÿÿÿÿÿÿÿÿÐÿ1ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿÿ÷ÿ ÿÿÿÿ»ÿ%ÿÿÿÿÿÿÿÿÿÿÿÿ¦ÿÿñÿ4ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ÷ÿîÿšÿFÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ¾ÿFÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿÿýÿ=ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿ ÿÿÿÿôÿ ÿÿÿßÿ"ÿÿÿÿÿÿÿÿÿÿÿýÿ7ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿúÿîÿÿñÿÿîÿúÿÿÿÿÿÿÿÿÿÿÿýÿúÿPÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿùÿÿÿ‚ÿ‚ÿßÿûìÿûïÿûòÿøÖÿÿÿýÿ ÿÿÿÁÿÿÿÿÿÿÿÿÓÿ@ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿúÿ ÿÿÿÿ¾ÿ ÿÿÿÿýÿÿÿÿÿÿÿˆÿ+ÿÿÿÿÿÿÿÿÿÿÿÿÿÿ÷ÿÿÿôÿÿÿ ÿCÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿµÿÿÿÿÿÿÿÿÿýÿ(ÿÿÿÿÿÿÿÿÿÿÿÿÿñÿ7ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ÷ÿèÿÜÿ ÿÿÿýÿÿÿÿÿÿÿ÷ÿ@ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿôÿ ÿÿÿ÷ÿ ÿÿÿýÿÿýÿÿÿýÿ%ÿÿÿÿÿÿÿÿÿÿÿÿ÷ÿMÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿùÿÿ‚ÿ‚ÿÜÿûìÿûïÿþïÿøÙÿÿÿ÷ÿ ÿÿÿÇÿÿÿÿÿÿÿÿÿÿÙÿ[ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÁÿ ÿÿÿ÷ÿ ÿÿÿˆÿ.ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿúÿÿÿÿÿÿÿÿÿÿ ÿIÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ¸ÿÿÿÿÿÿÿÿúÿ(ÿÿÿÿÿÿÿÿÿÿÿÿÿñÿ ÿÿÿýÿ"ÿÿÿÿÿÿÿÿÿÿÿ¾ÿÿÿýÿ ÿÿÿÿýÿ ÿÿÿÿ÷ÿ ÿÿÿýÿ4ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿúÿúÿÿÿÿÿÿÿÿÿýÿ ÿÿÿýÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿùÿ‚ÿ‚ÿÙÿûéÿûõÿûïÿøÙÿÿñÿÿÇÿÿÿÿÿÿÿÿÿÿÙÿ ÿÿÿýÿRÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ¬ÿˆÿ ÿÿÿÿýÿIÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ ÿÿÿýÿCÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ¸ÿÿÿÿÿÿÿÿÿýÿ(ÿÿÿÿÿÿÿÿÿÿÿÿÿýÿ:ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ¾ÿ ÿÿÿýÿ ÿÿÿÿúÿñÿÿÿôÿ:ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿúÿÿÿÿÿÿÿ÷ÿ ÿÿÿýÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿùÿÿ‚ÿ‚ÿÜÿøìÿøøÿþìÿøÁÿÇÿ ÿÿÿýÿÿÿýÿèÿ÷ÿ ÿÿÿÿúÿRÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ³ÿXÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿúÿîÿ¾ÿÿÿúÿ ÿÿÿÿýÿ"ÿÿÿÿÿÿÿÿÿÿÿýÿ ÿÿÿ¸ÿÿÿÿÿÿÿÿÿÿýÿ%ÿÿÿÿÿÿÿÿÿÿÿÿýÿ=ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÁÿ ÿÿÿýÿ ÿÿÿâÿÿñÿ%ÿÿÿÿÿÿÿÿÿÿÿÿýÿÿÿÿÿÿúÿ ÿÿÿÿñÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿùÿ‚ÿ‚ÿ²ÿûæÿø‘ÿúÿÿÿÿÿÿýÿÿÿúÿñÿ ÿÿÿúÿ ÿÿÿ÷ÿ@ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿúÿÿ‚ÿ­ÿRÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿúÿÿÿôÿÿÿ¾ÿ ÿÿÿýÿÿÿÿÿÿÿÿÿÿýÿ ÿÿÿÿ÷ÿÿÿ»ÿ"ÿÿÿÿÿÿÿÿÿÿÿýÿ ÿÿÿúÿÿÿÿÿÿÿÿÿÿÿýÿ1ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÁÿÿÿÿÿÿÿÍÿRÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿúÿÿúÿyÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿÿÿÿÿùÿÿ‚ÿ‚ÿ”ÿø­ÿÿÿÿñÿÿÿÿÿÿýÿÿÿÿÿÿúÿÿÿñÿ ÿÿÿýÿ ÿÿÿôÿ=ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿžÿsÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿÄÿ=ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿÿýÿÿúÿÍÿ ÿÿÿýÿ"ÿÿÿÿÿÿÿÿÿÿÿôÿÿÿÿÿÿÿÿÿÿúÿÿÿÿÿÿÿÿÿÿúÿ ÿÿÿÿ¾ÿ ÿÿÿÊÿ4ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿ(ÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿÿÿÿÿÿÿÿÿÿúÿeÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿùÿÿÿ‚ÿ‚ÿ—ÿø­ÿÿÿÿîÿ"ÿÿÿÿÿÿÿÿÿÿÿýÿ ÿÿÿîÿÿÿÿÿÿÿ÷ÿFÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿžÿ ÿÿÿýÿ ÿÿÿÿúÿXÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÄÿÿÿÿÿÿÿÿýÿ@ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÓÿ ÿÿÿ÷ÿ ÿÿÿýÿ ÿÿÿÿîÿ ÿÿÿÿýÿ"ÿÿÿÿÿÿÿÿÿÿÿýÿÿÿúÿýÿ»ÿ ÿÿÿÿÓÿ7ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ÷ÿIÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿ%ÿÿÿÿÿÿÿÿÿÿÿÿýÿúÿ5ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿùÿÿÿ°ÿã‚ÿ‡ÿø¼ÿÿÿøÿÿÿÿëÿ+ÿÿÿÿÿÿÿÿÿÿÿÿÿÿëÿÿÿÿÿÿýÿ"ÿÿÿÿÿÿÿÿÿÿÿýÿ+ÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ¤ÿÿÿÿÿÿúÿôÿUÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÁÿÿÿÿÿÿÿñÿÿýÿ+ÿÿÿÿÿÿÿÿÿÿÿÿÿÿ÷ÿÙÿÿñÿÿúÿ ÿÿÿÿîÿ4ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿ ÿÿÿµÿÿÿÿÿÿÿÿÓÿÿÿÿÿÿýÿÿÿÿÿÿÿÿÿÿÿúÿyÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿñÿúÿÿÿÿÿÿÿÿÿÿÿúÿù­ÿÝ‚ÿ‡ÿø¼ÿÿÿøÿÿÿÿèÿ%ÿÿÿÿÿÿÿÿÿÿÿÿèÿÿÿÿÿÿýÿÿÿÿÿÿýÿýÿ ÿÿÿýÿ+ÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ§ÿÿÿÿÿÿÿñÿXÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÄÿÿÿÿÿÿÿåÿ+ÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿÿ»ÿÿÿÿÿÿÿñÿ@ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ²ÿÿÿýÿ ÿÿÿÐÿ ÿÿÿúÿFÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿUÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿèÿÿÿ÷ÿ ÿÿÿõÿû°ÿÚ‚ÿ‡ÿø¼ÿÿÿøÿÿÿÿèÿÿÿÿÿÿÿýÿ ÿÿÿåÿ"ÿÿÿÿÿÿÿÿÿÿÿñÿ ÿÿÿýÿÿÿÿÿÿúÿ ÿÿÿÿ‚ÿ§ÿÿÿúÿ ÿÿÿ÷ÿUÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÁÿ ÿÿÿýÿ ÿÿÿåÿ%ÿÿÿÿÿÿÿÿÿÿÿÿýÿ ÿÿÿÿñÿÓÿ ÿÿÿýÿ ÿÿÿúÿÿÿÿÿÿÿÿÿúÿ"ÿÿÿÿÿÿÿÿÿÿÿ²ÿÿÿôÿÿÿÐÿÿôÿdÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿúÿ.ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ¼ÿû°ÿû‚ÿ‚ÿåÿø¼ÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿúÿ(ÿÿÿÿÿÿÿÿÿÿÿÿÿëÿÿÿÿÿÿÿÿÿÿÿèÿ ÿÿÿúÿ ÿÿÿÿýÿ ÿÿÿ‚ÿ§ÿÿÿôÿÿÿ÷ÿ+ÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿ%ÿÿÿÿÿÿÿÿÿÿÿÿôÿÿÖÿ ÿÿÿ÷ÿ ÿÿÿèÿ7ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿôÿÿÿÙÿ ÿÿÿ÷ÿÿÿÿÿÿÿÿýÿÿÿÿÿÿýÿ ÿÿÿÿýÿ ÿÿÿÿ¯ÿÿîÿ»ÿÿÿÿÿÿýÿOÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿúÿÿÿÿÿÿÿÿÿÿÿ­ÿû°ÿþ‚ÿ‚ÿâÿø¼ÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿýÿ.ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿñÿ ÿÿÿýÿÿÿÿÿÿâÿ ÿÿÿýÿÿÿÿÿÿÿÿÿ‚ÿ¡ÿîÿñÿ ÿÿÿÿýÿFÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿ ÿÿÿÿåÿÿúÿÿýÿÿúÿÿèÿ=ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿúÿ ÿÿÿ÷ÿÿôÿÿÿúÿÿñÿÿúÿÿýÿ7ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿËÿ ÿÿÿ÷ÿsÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ­ÿû°ÿþ‚ÿ‚ÿâÿø¼ÿJÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿúÿ ÿÿÿôÿÿÿúÿÿÿÿÿÿÿâÿ"ÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿöÿ ÿÿÿ÷ÿUÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿîÿýÿ ÿÿÿýÿýÿ ÿÿÿâÿ4ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿÿÿÿÿÿÿúÿ ÿÿÿÿ÷ÿ ÿÿÿÙÿ ÿÿÿÿýÿÿÿÿÿÿýÿÿÿÿÿÿÿÿ‚ÿÈÿîÿÿÿÿÿÿÿÿÿÿýÿRÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ°ÿû°ÿû‚ÿ‚ÿåÿøËÿ2ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿÿÿÿÿúÿ ÿÿÿÿúÿÿÿ÷ÿÿÿúÿÿÿÿÿÿÿÿÿåÿÿÿÿÿÿýÿ ÿÿÿ‚ÿ‚ÿðÿÿ÷ÿ ÿÿÿýÿIÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿôÿ(ÿÿÿÿÿÿÿÿÿÿÿÿÿâÿ:ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿÿÿÿÿ÷ÿÿÿÿÿÿÿÿÿÿÿÖÿ ÿÿÿ÷ÿ ÿÿÿ÷ÿ ÿÿÿýÿÿÿ‚ÿÂÿÿúÿCÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿ.ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ³ÿû­ÿû‚ÿ‚ÿèÿøËÿ2ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿúÿýÿÿôÿÿÿôÿôÿ+ÿÿÿÿÿÿÿÿÿÿÿÿÿÿåÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿäÿÿÿúÿFÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿúÿ(ÿÿÿÿÿÿÿÿÿÿÿÿÿÙÿúÿÿÿÿÿÿýÿ(ÿÿÿÿÿÿÿÿÿÿÿÿÿñÿÿÿÿÿÿÿÿÿÐÿÿñÿÿ÷ÿ ÿÿÿ÷ÿ ÿÿÿ‚ÿËÿ"ÿÿÿÿÿÿÿÿÿÿÿúÿ"ÿÿÿÿÿÿÿÿÿÿÿôÿÿúÿÿÿÿÿÿÿÿÿÿÿ³ÿû°ÿÚ‚ÿ‡ÿø¼ÿ,ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿâÿîÿÿýÿÿÿÿÿÿÿúÿ ÿÿÿÿèÿ%ÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿäÿôÿ ÿÿÿýÿ ÿÿÿ÷ÿÿÿÿÿÿÿÿÿÿýÿÿÿýÿ%ÿÿÿÿÿÿÿÿÿÿÿÿÇÿFÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿÿÿÿÿÿÁÿîÿýÿÿñÿÿ‚ÿÅÿFÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿåÿÿÿÿÿÿÿÿÿÿ°ÿû°ÿÚ‚ÿ‡ÿøÓÿÿñÿþ1ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿñÿÿÿôÿ ÿÿÿýÿ ÿÿÿÿôÿýÿëÿ ÿÿÿýÿ ÿÿÿÿúÿ ÿÿÿ‚ÿ‚ÿÕÿÿÿÿÿÿÿîÿÿÿÿÿÿÿýÿ4ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÄÿFÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿÿÿÿÿÄÿÿÿôÿÿÿ‚ÿ§ÿCÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿèÿÿÿÿÿÿÿÿÿÿ­ÿû°ÿÚ‚ÿ‡ÿøÖÿÿÿûÿDÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿôÿ ÿÿÿÿúÿ ÿÿÿÿýÿ ÿÿÿÓÿ ÿÿÿýÿÿÿÿÿÿúÿÿÿ‚ÿ‚ÿÒÿ ÿÿÿÿîÿ+ÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿ"ÿÿÿÿÿÿÿÿÿÿÿÄÿ[ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÇÿ ÿÿÿúÿ ÿÿÿ‚ÿ¤ÿ ÿÿÿÿúÿÿÿÿÿÿÿÿýÿÿÿÿÿÿëÿ ÿÿÿýÿÿÿÿÿÿ­ÿû‚ÿ‚ÿŽÿøÖÿ ÿÿÿþÿGÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿúÿ"ÿÿÿÿÿÿÿÿÿÿÿýÿÿÿÿÿÿÓÿÿýÿÿÿÿÿÿÿ÷ÿ‚ÿ‚ÿÏÿ ÿÿÿÿñÿ1ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿ"ÿÿÿÿÿÿÿÿÿÿÿÊÿÿÿÿÿÿýÿLÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÇÿÿÿÿÿÿÿÿ‚ÿ¡ÿÿÿÿÿÿÿÿÿÿ÷ÿúÿÿÿÿÿÿîÿ ÿÿÿ÷ÿ ÿÿÿªÿû‚ÿ‚ÿŽÿøÓÿÿÿÿþ4ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿÿÿÿÿúÿÿÿÿÿÿÿÿÿúÿ ÿÿÿýÿ ÿÿÿÓÿ ÿÿÿýÿ ÿÿÿ‚ÿ‚ÿÉÿÿÿÿÿÿÿ÷ÿ^ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÐÿÿÿÿÿÿÿÿýÿ7ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿÿÿÿÿÿÇÿÿÿÿÿÿ‚ÿ¡ÿÿÿÿÿÿÿÿÿÿîÿÿÿýÿ ÿÿÿîÿÿñÿÿ§ÿû‚ÿ‚ÿŽÿøÍÿÿÿÿþÿÿþÿÿÿÿÿÿþÿ,ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿúÿÿÿÿÿÿÿúÿ ÿÿÿ÷ÿ ÿÿÿÙÿ ÿÿÿ÷ÿÿÿ‚ÿ‚ÿÌÿ ÿÿÿýÿ ÿÿÿýÿ ÿÿÿýÿÿýÿÿÿÿÿÿÿÿúÿÿÿÿÿÿþÿÿÿÿÿÿÿÿÐÿ ÿÿÿúÿFÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿ ÿÿÿÁÿ ÿÿÿ‚ÿ¡ÿ ÿÿÿýÿ ÿÿÿÿîÿÿÿ÷ÿ ÿÿÿ‚ÿüÿû‚ÿäÿõ‚ÿ·ÿøÍÿÿÿÿþÿÿþÿÿÿÿÿÿþÿÿÿÿÿÿÿÿÿÿÿýÿ ÿÿÿ÷ÿÿÿÿÿÿÿúÿÿôÿ ÿÿÿÙÿÿÿôÿÿÿ‚ÿ‚ÿÏÿ ÿÿÿ÷ÿ ÿÿÿýÿÿúÿúÿÿÿÿÿÿÿúÿÿÿÿÿÿÿþÿÿÿÿÿÿÿÿÐÿÿÿôÿCÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿúÿ¾ÿÿÿÿÿÿ‚ÿ§ÿ ÿÿÿ÷ÿ ÿÿÿÿñÿÿñÿÿÿ‚ÿüÿû‚ÿêÿæ‚ÿÀÿøèÿîÿýÿÿÿÿþCÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿôÿÿÿÿÿÿÿÿèÿÿÓÿ‚ÿ‚ÿ´ÿÿñÿÿëÿ1ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿÿÿÿÿÊÿîÿFÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ¾ÿÿÿÿÿÿÿÿ‚ÿ§ÿÿúÿÿÿÿÿÿÿÿ‚ÿÒÿû‰ÿûïÿÝ‚ÿÃÿøëÿÿÿôÿÿþLÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿñÿÿÿÿÿÿÿÿÿÿ÷ÿÿ‚ÿ‚ÿ‚ÿÇÿÿÿÿÿÿÿÿþÿÿÿÿÿÿÿÿÿÿþÿÿ©ÿIÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÁÿ ÿÿÿúÿ ÿÿÿ‚ÿ¡ÿ ÿÿÿúÿ ÿÿÿ‚ÿÕÿûÿïõÿÚ‚ÿÆÿøëÿ ÿÿÿúÿÿÿþ%ÿÿÿÿÿÿÿÿÿÿÿÿÿôÿÿÿÿÿÿÿÿÿôÿ ÿÿÿýÿÿÿÿÿÿúÿ ÿÿÿ‚ÿ‚ÿ‚ÿÇÿÿÿÿÿÿÿþÿÿÿÿÿÿúÿÿþÿÿÿñÿÿ¾ÿÿúÿÿýÿ.ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ¾ÿÿÿôÿÿÿ‚ÿ¡ÿÿÿôÿÿÿ‚ÿÕÿû’ÿéûÿøéÿõ‚ÿÉÿøèÿÿÿÿÿÿÿÿÿûÿÿÿÿÿÿûÿÿÿÿôÿÿÿÿÿÿÿÿÿÿúÿ ÿÿÿ÷ÿ ÿÿÿÿýÿ ÿÿÿ‚ÿ‚ÿ‚ÿÁÿÿÿúÿþ ÿÿÿÿÿþ.ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ¬ÿ(ÿÿÿÿÿÿÿÿÿÿÿÿÿµÿîÿ‚ÿ›ÿîÿ‚ÿÒÿû•ÿÚãÿø‚ÿÉÿøåÿÿÿÿÿÿÿÿûÿ ÿÿÿÿøÿÿÿÿôÿÿýÿÿÿÿÿÿÿ÷ÿÿñÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ¾ÿúÿÿþ ÿÿÿÿÿþ+ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ©ÿÿÿÿÿÿýÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿíÿû•ÿûìÿøÝÿû‚ÿÉÿøâÿ ÿÿÿòÿ ÿÿÿÿøÿÿÿÿîÿ ÿÿÿúÿ ÿÿÿâÿ ÿÿÿÿúÿÿ‚ÿ‚ÿ‚ÿÑÿÿÿÿ÷ÿÿÿþÿÿÿÿÿÿõÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿëÿû˜ÿûéÿûÚÿû‚ÿÉÿøåÿ ÿÿÿÿþ+ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿîÿÿñÿÿÿñÿÿþÿÿÿÿþ ÿÿÿÿýÿ ÿÿÿ‚ÿ‚ÿ‚ÿÔÿÿÿÿþÿ2ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿ ÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿèÿû˜ÿûéÿøÝÿû‚ÿÉÿøèÿÿÿÿÿÿþ%ÿÿÿÿÿÿÿÿÿÿÿÿÿÐÿñÿÿÿþÿÿÿÿþÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿÑÿÿÿÿþÿ2ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿýÿ ÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿèÿû˜ÿûéÿøÝÿû‚ÿÉÿøèÿÿÿúÿ ÿÿÿûÿÿÿÿ¬ÿÿþÿÿÿÿþÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿÎÿÿÿÿúÿþÿÿÿþÿÿÿÿÿÿþ%ÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿëÿû˜ÿûæÿþÚÿþ‚ÿÆÿøëÿÿÿôÿÿÿûÿÿÿÿ©ÿþÿÿÿÿþÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿÎÿÿÿÿøÿÿÿÿÿÿÿÿÿÿþÿÿÿÿÿÿÿÿÿýÿ ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿû•ÿþ¿ÿû‚ÿÆÿøèÿîÿøÿÿÿÿ×ÿÿÿÙÿþÿÿÿÿþÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿÚÿ9ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿÿÿÿÿ÷ÿ ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿñÿû•ÿõËÿû‚ÿÃÿøÈÿÿÿÿâÿþÿ ÿÿÿÿýÿìÿ/ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿÝÿVÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ÷ÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿû’ÿ¡‚ÿÞÿøôÿëÿïÿÿÿÿåÿÿÿþÿÿÿÿÿÿÿïÿ2ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÈÿÿÿÿ‚ÿ‚ÿ”ÿGÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿßÿû’ÿ¡‚ÿÞÿøôÿÿõÿÿÿÿÊÿÿÿþÿÿÿÿÿÿÿïÿ5ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿËÿÿÿÿ‚ÿ‚ÿ”ÿAÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÙÿû‰ÿª‚ÿÞÿøôÿÿÿøÿ ÿÿÿÿëÿñÿÿÿúÿÿþÿÿÿÿÿÿåÿÿÿþ%ÿÿÿÿÿÿÿÿÿÿÿÿÿËÿÿÿÿ‚ÿ‚ÿ”ÿ8ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÐÿû‚ÿ‚ÿŽÿøñÿÿÿýÿþÿÿÿîÿ ÿÿÿ÷ÿ ÿÿÿþÿ#ÿÿÿÿÿÿÿÿÿÿÿÿëÿþÿÿÿÿÿÿÿÿÿÿÿÂÿÿÿÿ‚ÿ‚ÿ”ÿ8ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‰ÿÿÿ‚ÿ‚ÿ—ÿÿÿÿ‚ÿÃÿû‚ÿ‚ÿŽÿøîÿÿÿÿþÿÿÿèÿÿÿýÿÿÿÿþ(ÿÿÿÿÿÿÿÿÿÿÿÿÿÿæÿ,ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÑÿÿÿÿ‚ÿ‚ÿ”ÿ>ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿ›ÿÿÿ‚ÿ‚ÿ—ÿÿÿÿ‚ÿÃÿû‚ÿ‚ÿŽÿøîÿÿÿÿþÿÿÿèÿÿÿÿÿÿÿþÿ)ÿÿÿÿÿÿÿÿÿÿÿÿÿÿïÿ5ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿàÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ¬ÿÿÿøÿÿÿÿþÿ,ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿ›ÿÿÿ‚ÿ‚ÿ—ÿÿÿÿ‚ÿÃÿû‚ÿ‚ÿŽÿøòÿ)ÿÿÿÿÿÿÿÿÿÿÿÿÿÿ÷ÿ ÿÿÿÿûÿ#ÿÿÿÿÿÿÿÿÿÿÿÿéÿ5ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿàÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿßÿÿÿÿ×ÿÿÿøÿÿÿÿþÿ ÿÿÿÿþÿÿÿÿÿÿÿòÿÿÿÿ›ÿÿÿ‚ÿ‚ÿ—ÿÿÿÿ‚ÿÃÿû‚ÿ‚ÿŽÿøòÿ,ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿúÿ ÿÿÿÿ÷ÿÿÿÿþÿÿÿÿÿÿÿéÿ,ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ×ÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿßÿÿÿÿ×ÿ ÿÿÿÿþÿÿÿÿÿÿÿÿÿþÿ ÿÿÿÿïÿ ÿÿÿÿ›ÿÿÿ‚ÿ‚ÿ—ÿÿÿÿ‚ÿÃÿû‚ÿ‚ÿŽÿøôÿþCÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ÷ÿÿÿþÿÿÿÿÿÿÿÚÿÿÿÿûÿÿÿÿÿÿÈÿ ÿÿÿÿ‚ÿ‚ÿÓÿÿÿÿÿÿéÿÿÿÿþÿ ÿÿÿÿþÿ2ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿûÿ ÿÿÿÿªÿ#ÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿµÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿÒÿû‚ÿ‚ÿŽÿøôÿÿõÿÿÿÿñÿÿÿÿÿÿúÿ ÿÿÿúÿÿþ ÿÿÿÿýÿ×ÿÿÿÿûÿÿÿÿÿÿÎÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿßÿÿÿÿÿÿéÿÿÿÿþÿbÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ¹ÿ#ÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿýÿÿÿ¿ÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿÒÿû‚ÿ‚ÿŽÿøôÿÿõÿÿÿÿîÿ ÿÿÿ÷ÿ ÿÿÿúÿÿþ ÿÿÿÿÑÿÿÿÿûÿÿÿÿÿÿ×ÿÿÿþÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿßÿÿÿÿÿÿìÿqÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÅÿÿÿþÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿýÿÿÿ¿ÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿÒÿû‚ÿ‚ÿŽÿøãÿÿÿÿñÿÿÿÿÿÿ÷ÿÿÿýÿÿÿþÿÿÿÎÿ,ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿæÿ,ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿôÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿøÿ8ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿøÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿÅÿÿÿþÿÿÿÿøÿÿÿ‚ÿ‚ÿîÿÿÿ°ÿÿÿÿ‚ÿÏÿÿÿÿþÿû‚ÿ‚ÿŽÿøãÿÿÿÿôÿÿÿÿÿÿÿÿ÷ÿýÿÿÿúÿ ÿÿÿÔÿ,ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿæÿ,ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿôÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿøÿDÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿ¿ÿÿÿþÿÿÿÿøÿÿÿ‚ÿ‚ÿîÿÿÿÅÿÿÿòÿÿÿÿûÿÿÿÿþÿÿÿÿ‚ÿíÿ ÿÿÿÿþÿû‚ÿ‚ÿŽÿøãÿÿÿÿ÷ÿ ÿÿÿúÿ ÿÿÿýÿÿÿÿÿÿýÿ ÿÿÿÿ¿ÿÿÿÿÿÿÝÿÿÿþÿÿÿÿþÿÿÿÿÿÿÿ‚ÿ‚ÿèÿnÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿ¿ÿÿÿþÿÿÿÿøÿÿÿ‚ÿ‚ÿîÿÿÿÑÿÿÿÿþÿÿÿòÿ ÿÿÿÿþÿÿÿÿþÿÿÿÿïÿÿÿÿÂÿÿÿÿþÿÿÿÚÿ ÿÿÿÿþÿû‚ÿ‚ÿŽÿøÐÿÿÿôÿÿÿÿÿÿÿÿÿýÿÿÿÿþÿÿÿÂÿÿÿÿÿÿãÿ;ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ±ÿÿÿÿÑÿnÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿ¿ÿÿÿþÿÿÿÿøÿÿÿ‚ÿ‚ÿîÿÿÿÑÿÿÿÿþÿÿÿøÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿïÿÿÿÿÂÿÿÿÿþÿÿÿÚÿ ÿÿÿÿþÿû‚ÿ‚ÿŽÿøîÿÿñÿÿúÿýÿÿ÷ÿ"ÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿÿÿÈÿÿÿÿÿÿìÿDÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ±ÿÿÿÿÑÿGÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿ ÿÿÿÿòÿÿÿÿìÿÿÿÿÿÿÿËÿ/ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿýÿ#ÿÿÿÿÿÿÿÿÿÿÿÿàÿÿÿÿÿÿÿøÿ)ÿÿÿÿÿÿÿÿÿÿÿÿÿÿïÿÿÿÿÂÿÿÿÿþÿÿÿÚÿ ÿÿÿÿþÿû‚ÿ‚ÿŽÿøñÿ ÿÿÿ÷ÿÿÿ÷ÿ ÿÿÿúÿ ÿÿÿýÿÿÿÿÿÿûÿÿÿÿÿÿÈÿÿÿÿÿÿìÿDÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ±ÿÿÿÿÝÿSÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿ ÿÿÿÿÔÿÿÿÿÿÿÿËÿ/ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿýÿ#ÿÿÿÿÿÿÿÿÿÿÿÿéÿÿÿþÿÿÿÿÿÿÿøÿÿÿÿþÿÿÿÿÿÿÿÿÿÿÿïÿÿÿÿÂÿÿÿÿþÿÿÿæÿÿÿÿÿÿÿÿÿÿùÿÿÿÿÿÿ‚ÿ‚ÿ ÿøîÿ ÿÿÿýÿ ÿÿÿôÿÿÿÿÿÿÿÿÿúÿ ÿÿÿÿûÿÿÿÿÿÿþÿÿÿÚÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿìÿÿÿþÿÿÿÿþÿÿÿÿÿÿÿ‚ÿ¢ÿÿÿÿÝÿSÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿøÿÿÿÚÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿÑÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿ‚ÿ‚ÿúÿÿÿÚÿ\ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿÈÿÿÿÿÿÿþÿÿÿéÿÿÿÿÿÿÿÿÿÿÿùÿÿÿÿÿÿ‚ÿ‚ÿ ÿøëÿÿÿÿÿÿÿøÿ8ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿÿÿþÿÿÿøÿÿÿÿìÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿìÿÿÿþÿÿÿÿøÿ ÿÿÿÿ‚ÿ¢ÿÿÿÿÝÿGÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿûÿÿÿøÿÿÿÚÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿËÿÿÿÿÿÿÿÿÿÿøÿÿÿÿ›ÿÿÿÿ‚ÿêÿÿÿàÿ}ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿàÿ/ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿøÿÿÿÿÿÿÿÿÿÿÿùÿÿÿÿÿÿ‚ÿ‚ÿ ÿøèÿ ÿÿÿÿõÿÿÿÿýÿÿÿÿÿÿÿÿÿÿÿþ%ÿÿÿÿÿÿÿÿÿÿÿÿÿøÿÿÿÿìÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿìÿÿÿþÿÿÿÿøÿ ÿÿÿÿ‚ÿ±ÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿìÿGÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿûÿÿÿøÿÿÿÚÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿËÿÿÿÿÿÿÿÿÿÿøÿÿÿÿìÿÿÿìÿÿÿÑÿÿÿÿãÿÿÿÿÿÿàÿ}ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿòÿÿÿÿøÿ/ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿïÿÿÿÿÿÿÿþÿû‚ÿ‚ÿŽÿøéÿÿÿÿÿÿõÿÿÿÿýÿ ÿÿÿÿýÿ ÿÿÿÿþ+ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿÝÿÿÿÿþÿÿÿæÿÿÿÿÿÿÿøÿ ÿÿÿÿþÿÿÿÿ‚ÿ½ÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿòÿMÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ°ÿ ÿÿÿÿÅÿ2ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿìÿÿÿìÿÿÿÑÿÿÿÿþÿ ÿÿÿÿòÿÿÿÿÿÿÚÿwÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿþÿÿÿÿøÿ/ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿïÿÿÿÿÿÿÿþÿû‚ÿ‚ÿŽÿøëÿþÿÿÿÿÿÿøÿ*ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþ7ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÝÿÿÿÿþÿÿÿòÿÿÿûÿ ÿÿÿÿòÿ ÿÿÿÿþÿÿÿÿ‚ÿ½ÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿûÿhÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÂÿ ÿÿÿÿ×ÿÿÿÿþÿJÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿìÿÿÿ×ÿÿÿÿÿÿþÿ ÿÿÿÿòÿÿÿÿÿÿéÿeÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿøÿÿÿÿòÿ ÿÿÿÿþÿÿÿÿøÿÿÿþÿ#ÿÿÿÿÿÿÿÿÿÿÿÿìÿÿÿÿÿÿÿÿú‚ÿ‚ÿŽÿøîÿÿþÿÿÿÿÿÿÿûÿ/ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿ8ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿæÿ)ÿÿÿÿÿÿÿÿÿÿÿÿÿÿõÿÿÿéÿÿÿÿÿÿ‚ÿ®ÿÿÿÿìÿ)ÿÿÿÿÿÿÿÿÿÿÿÿÿÿûÿ8ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿËÿ#ÿÿÿÿÿÿÿÿÿÿÿÿõÿÿÿþÿÿÿÿÿÿþÿJÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿìÿÿÿ×ÿÿÿÿÿÿþÿ ÿÿÿÿòÿÿÿ•ÿÿÿÿæÿbÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿõÿÿÿÿòÿ ÿÿÿÿþÿÿÿÿþÿ2ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿìÿÿÿÿÿÿÿÿú‚ÿ‚ÿŽÿøñÿÿÿþÿÿÿþÿ>ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿõÿ8ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿïÿ)ÿÿÿÿÿÿÿÿÿÿÿÿÿÿõÿÿÿéÿÿÿÿÿÿ‚ÿ®ÿÿÿÿéÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿûÿÿÿÿÿÿÿÿÿÿÿþÿÿÿ¹ÿ#ÿÿÿÿÿÿÿÿÿÿÿÿõÿÿÿþÿÿÿÿÿÿþÿ ÿÿÿÿþÿÿÿÿþÿ/ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿìÿÿÿàÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿòÿÿÿ•ÿÿÿÿæÿbÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿõÿÿÿÿòÿ ÿÿÿÿþÿÿÿÿþÿ2ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿøÿÿÿûÿÿÿÿÿÿÿÿú‚ÿ‚ÿŽÿøîÿÿþÿÿÿþÿDÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿûÿ8ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿïÿ)ÿÿÿÿÿÿÿÿÿÿÿÿÿÿõÿÿÿéÿÿÿÿÿÿ‚ÿ®ÿÿÿÿéÿ#ÿÿÿÿÿÿÿÿÿÿÿÿøÿÿÿÿÿÿÿÿÿøÿÿÿ¹ÿ#ÿÿÿÿÿÿÿÿÿÿÿÿõÿÿÿþÿÿÿÿÿÿþÿ}ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿïÿJÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿªÿÿÿÿÿÿøÿ ÿÿÿÿþÿÿÿõÿSÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿõÿÿÿÿòÿMÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿ%ÿÿÿÿÿÿÿÿÿÿÿÿÿú‚ÿ‚ÿŽÿøøÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿôÿ"ÿÿÿÿÿÿÿÿÿÿÿþÿ/ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ×ÿÿÿþÿÿÿÿþÿMÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ½ÿÿÿÿòÿ,ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿ,ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿªÿ ÿÿÿÿøÿÿÿÿÿÿÿþÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿïÿSÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÂÿÿÿûÿÿÿÿÿÿÿøÿ ÿÿÿÿþÿÿÿõÿ ÿÿÿÿþÿYÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿú‚ÿ‚ÿŽÿøøÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿ÷ÿÿÿÿÿÿÿÿÿýÿÿûÿ2ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿàÿhÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ½ÿÿÿÿòÿ,ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿ,ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿªÿ ÿÿÿÿþÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ ÿÿÿÿÿøÿÿÿæÿAÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿòÿÿÿÿÂÿÿÿûÿÿÿÿÿÿÿøÿ ÿÿÿÿþÿÿÿõÿ ÿÿÿÿþÿÿÿÿþÿ ÿÿÿÿòÿ,ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿûÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿù ÿÿÿÿ‚ÿ‚ÿšÿøéÿÿÿÿïÿÿÿÿúÿÿÿÿÿÿÿÿÿéÿ8ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿìÿhÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿÆÿÿÿìÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿòÿ,ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿªÿ ÿÿÿÿþÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ ÿÿÿÿÿþÿ ÿÿÿÿæÿ8ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿòÿÿÿÿÂÿ2ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿõÿ ÿÿÿÿþÿÿÿÿþÿ ÿÿÿÿìÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿûÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿù ÿÿÿÿ‚ÿ‚ÿšÿøéÿÿÿÿïÿÿÿÿúÿÿÿýÿÿÿÿÿÿéÿ5ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿìÿ2ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿøÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿÀÿÿÿìÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿãÿÿÿÿ•ÿ ÿÿÿÿþÿDÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿþÿ8ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿ ÿÿÿÿæÿ8ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿûÿÿÿþÿÿÿÿÂÿnÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÝÿÿÿÿÿÿÿõÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿù ÿÿÿÿ‚ÿ‚ÿšÿøéÿÿÿÿïÿÿÿÿúÿÿýÿÿÿÿÿÿÿõÿAÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿìÿÿÿÿÿÿÿÿÿþÿ ÿÿÿÿûÿÿÿøÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿÑÿÿÿÿþÿÿÿƒÿÿÿìÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿãÿÿÿÿžÿPÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿòÿÿÿÿûÿ5ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿ ÿÿÿÿàÿÿÿþÿ2ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿûÿÿÿþÿÿÿÿÈÿtÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÝÿÿÿÿÿÿÿøÿPÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿ4ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿú‚ÿ‚ÿŽÿøéÿÿÿÿÙÿ ÿÿÿýÿ ÿÿÿøÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿÝÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿûÿÿÿéÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿàÿÿÿÿþÿÿÿ›ÿÿÿÿþÿÿÿÿþÿÿÿãÿÿÿÿÿÿÿÿÚÿÿÿÿžÿPÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿòÿÿÿÿûÿÿÿÿþÿ8ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿàÿÿÿþÿYÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿàÿbÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿïÿÿÿÿàÿnÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿ4ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿú‚ÿ‚ÿŽÿøéÿÿÿÿÜÿ ÿÿÿ÷ÿ ÿÿÿìÿÿÿÿþÿ ÿÿÿÿþÿÿÿÿìÿDÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿìÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿàÿÿÿÿþÿÿÿ›ÿÿÿÿþÿÿÿÿþÿÿÿøÿÿÿÿûÿÿÿÿÿÿÿÿÿÿÚÿÿÿÿžÿPÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿãÿÿÿÿþÿ8ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿàÿbÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿìÿÿÿûÿVÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿËÿbÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿìÿ4ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿú‚ÿ‚ÿŽÿøÝÿÿÿâÿÿñÿÿéÿÿÿÿþÿ ÿÿÿÿþÿÿÿÿìÿDÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿìÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿàÿÿÿÿþÿÿÿ›ÿÿÿÿþÿÿÿÿþÿÿÿøÿÿÿÿûÿÿÿÿÿÿÿÿÿÿÚÿÿÿÿ•ÿGÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿãÿÿÿÿþÿ8ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿàÿbÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿìÿÿÿûÿ,ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿËÿbÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿéÿÿÿÿÿÿÿÿÿÿÿòÿÿÿú‚ÿ‚ÿŽÿøÝÿÿÿ°ÿÿÿÿþÿ ÿÿÿÿþÿÿÿÿìÿ5ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÝÿÿÿÿþÿ ÿÿÿÿÑÿÿÿÿþÿÿÿòÿÿÿ°ÿSÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿáÿGÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÝÿÿÿÿþÿ ÿÿÿÿþÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿõÿÿÿÿÿÿÿÿÿÿÿþÿÿÿøÿ2ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿàÿÿÿòÿ ÿÿÿÿûÿÿÿÿÿÿÿþÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿËÿ;ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿþÿÿÿÿÿÿÿÿÿéÿÿÿÿÿÿÿÿÿÿÿòÿÿÿú‚ÿ‚ÿŽÿøÝÿÿÿ°ÿÿÿÿïÿÿÿÿÝÿÿÿþÿÿÿÿÿÿøÿÿÿàÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿìÿ5ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ³ÿVÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿáÿGÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÑÿ5ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿøÿ)ÿÿÿÿÿÿÿÿÿÿÿÿÿÿûÿ5ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿàÿ8ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿ5ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ¿ÿJÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿãÿÿÿÿÿÿÿÿÿìÿû‚ÿ‚ÿŽÿøÝÿÿÿ°ÿÿÿÿÂÿÿÿþÿÿÿÿÿÿøÿÿÿàÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿìÿ5ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ¿ÿ2ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿþÿÿÿÿÿÿÿ‚ÿÞÿDÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÂÿ2ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿ2ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿûÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿÝÿ2ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿøÿ5ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ¿ÿGÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿûÿÿÿãÿÿÿÿÿÿþÿÿÿìÿû‚ÿ‚ÿŽÿøÝÿÿÿ‚ÿçÿÿÿþÿÿÿÿÿÿøÿÿÿÑÿ ÿÿÿÿàÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿøÿÿÿÿÿÿÿæÿÿÿìÿ\ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿçÿDÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ¶ÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿþÿ2ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿûÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿìÿ/ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿûÿ,ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿ ÿÿÿÿ°ÿ ÿÿÿÿøÿÿÿÿÿÿÿøÿÿÿÿþÿÿÿÿãÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿìÿû‚ÿ‚ÿŽÿøìÿ#ÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿöÿÿÿþÿÿÿÿòÿÿÿÑÿ ÿÿÿÿÑÿÿÿÿþÿÿÿòÿÿÿÿÿÿÿæÿÿÿìÿ\ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿÕÿ2ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ¶ÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿþÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿøÿÿÿÿÿÿÿþÿÿÿÿÿÿþÿÿÿÿìÿ/ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿõÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿþÿ ÿÿÿÿ°ÿÿÿÿÿÿÿþÿÿÿÿÿÿÿøÿÿÿÿþÿÿÿÿãÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿìÿû‚ÿ‚ÿŽÿøìÿ#ÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿöÿÿÿþÿÿÿÿ¼ÿÿÿûÿÿÿ×ÿÿÿÿþÿ)ÿÿÿÿÿÿÿÿÿÿÿÿÿÿéÿÿÿàÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿÿÿÿÿÿÿÿ‚ÿÌÿÿÿìÿÿÿøÿÿÿÿ³ÿÿÿÿþÿ ÿÿÿÿþÿ2ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿàÿÿÿþÿÿÿÿÿÿÑÿÿÿøÿÿÿÿÿÿãÿÿÿøÿÿÿÿþÿ ÿÿÿÿ°ÿÿÿÿþÿÿÿþÿÿÿÿÿÿõÿÿÿÿÈÿÿÿÿÝÿû‚ÿ‚ÿŽÿøÝÿÿÿ‚ÿÒÿÿÿÿÈÿÿÿûÿÿÿæÿÿÿøÿ5ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿéÿÿÿïÿ5ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿÿÿÿÿÿÿÿ‚ÿÌÿÿÿìÿÿÿøÿÿÿÿ³ÿÿÿÿþÿAÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿàÿÿÿþÿÿÿÿÿÿÑÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿìÿÿÿøÿÿÿÿþÿ ÿÿÿÿ¤ÿÿÿþÿÿÿÿÿÿõÿÿÿÿÈÿÿÿÿÝÿû‚ÿ‚ÿŽÿøÝÿÿÿ‚ÿÒÿÿÿÿÈÿÿÿûÿÿÿæÿÿÿøÿÿÿÿÿÿÿòÿÿÿÿÿÿÿæÿÿÿïÿYÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿÏÿÿÿìÿÿÿ¡ÿÿÿÿþÿ>ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿãÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿÚÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿìÿÿÿøÿÿÿÿþÿ ÿÿÿÿ¤ÿÿÿþÿÿÿÿÿÿõÿÿÿÿÈÿÿÿÿÝÿû‚ÿ‚ÿŽÿøÝÿÿÿ‚ÿÒÿÿÿÿ¼ÿÿÿæÿ ÿÿÿÿþÿ ÿÿÿÿòÿÿÿÿÿÿÿÿÿæÿÿÿïÿYÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿÏÿÿÿìÿÿÿ•ÿÿÿÿþÿ2ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿãÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿÚÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿìÿÿÿìÿÿÿžÿÿÿøÿÿÿÿ³ÿÿÿÿÝÿû‚ÿ‚ÿŽÿøÝÿÿÿ‚ÿÒÿÿÿÿ¼ÿÿÿæÿÿÿÿÿÿÿþÿÿÿûÿPÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿïÿDÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ®ÿÿÿ•ÿÿÿÿþÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿãÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿìÿÿÿÿøÿÿÿÿÿÿÿÿõÿÿÿìÿÿÿ’ÿ#ÿÿÿÿÿÿÿÿÿÿÿÿ°ÿÿÿÿÝÿû‚ÿ‚ÿŽÿøÝÿÿÿ‚ÿÒÿÿÿÿËÿ#ÿÿÿÿÿÿÿÿÿÿÿÿõÿÿÿÿÿÿÿþÿÿÿûÿPÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿûÿÿÿûÿÿÿþÿÿÿÿþÿÿÿþÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿµÿ/ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿËÿÿÿÿþÿÿÿÿéÿÿÿÿõÿÿÿÿÿÿÿõÿÿÿ‚ÿöÿ#ÿÿÿÿÿÿÿÿÿÿÿÿƒÿû‚ÿ‚ÿŽÿø‚ÿ·ÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿÚÿqÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿøÿÿÿÿÿÿÿòÿÿÿûÿÿÿþÿÿÿÿþÿÿÿþÿÿÿÿøÿ ÿÿÿÿ‚ÿ‚ÿ¬ÿ/ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿËÿÿÿÿþÿÿÿÿþÿÿÿûÿÿÿþÿÿÿÿõÿ2ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿöÿÿÿ‚ÿóÿû‚ÿ‚ÿŽÿø‚ÿ·ÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿÚÿbÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿ ÿÿÿÿþÿÿÿÿøÿÿÿÿÿÿÿÿÿøÿÿÿûÿÿÿþÿÿÿÿþÿÿÿþÿÿÿÿøÿ ÿÿÿÿ‚ÿ‚ÿ£ÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿÎÿ,ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿþÿ;ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿöÿÿÿ‚ÿóÿû‚ÿ‚ÿŽÿø‚ÿ·ÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿËÿ ÿÿÿÿûÿPÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿøÿÿÿÿÿÿÿÿÿøÿÿÿûÿÿÿþÿÿÿÿþÿÿÿþÿÿÿÿøÿ ÿÿÿÿ‚ÿ‚ÿÿÿÿÿÿÿÿ¿ÿ,ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿGÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿöÿÿÿ‚ÿóÿû‚ÿ‚ÿŽÿø‚ÿ¨ÿÿÿÿ¼ÿ ÿÿÿÿøÿMÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿþÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿÿÿÿìÿÿÿìÿÿÿ‚ÿ‚ÿ—ÿÿÿÿÿÿÿ¿ÿ\ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿûÿÿÿ‚ÿçÿÿÿ‚ÿóÿû‚ÿ‚ÿŽÿø‚ÿ¨ÿÿÿÿ¼ÿ ÿÿÿÿþÿÿÿÿþÿGÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿþÿ;ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÚÿÿÿ‚ÿ‚ÿ—ÿÿÿÿþÿÿÿ°ÿÿÿÿþÿ8ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿòÿÿÿ‚ÿçÿÿÿ‚ÿóÿû‚ÿ‚ÿŽÿø‚ÿ¨ÿÿÿÿ¼ÿ ÿÿÿÿþÿÿÿÿÿÿþÿÿÿÿÿÿÿþÿÿÿûÿÿÿÿÿÿÿþÿVÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿéÿÿÿÿþÿÿÿ³ÿ5ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿÿÿòÿÿÿ‚ÿ‚ÿÓÿû‚ÿ‚ÿŽÿø‚ÿ¨ÿÿÿÿ¼ÿ ÿÿÿÿþÿÿÿÿÿÿþÿÿÿÿÿÿÿþÿwÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿéÿÿÿÿþÿÿÿ³ÿGÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿòÿÿÿ‚ÿ‚ÿÓÿû‚ÿ‚ÿŽÿø‚ÿ¨ÿÿÿÿÈÿ)ÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿÿÿÿþÿnÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿIÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿòÿÿÿ‚ÿ‚ÿÓÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿåÿ)ÿÿÿÿÿÿÿÿÿÿÿÿÿÿøÿ ÿÿÿÿþÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿûÿPÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿŒÿAÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ»ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿÙÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿòÿÿÿÿÿÿÿòÿPÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ4ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ¸ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿÙÿ,ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿéÿÿÿÿìÿÿÿÿÿÿÿÿÿÿþÿ2ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ4ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ¸ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿÖÿ)ÿÿÿÿÿÿÿÿÿÿÿÿÿÿéÿÿÿÿûÿ)ÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿ#ÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿðÿ2ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ¸ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿßÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿÝÿÿÿÿûÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿûÿÿÿÿÿÿÿÿÿþÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿðÿ ÿÿÿÿþÿÿÿÿþÿ ÿÿÿÿ‚ÿ‚ÿ¬ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿßÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿÝÿÿÿÿûÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿõÿÿÿÿÿÿÿþÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿêÿÿÿþÿÿÿÿþÿ ÿÿÿÿ‚ÿ‚ÿ¬ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿßÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿ¿ÿÿÿþÿÿÿÿÿÿïÿ ÿÿÿÿþÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿáÿÿÿÿþÿÿÿ‚ÿ‚ÿ¦ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿÐÿÿÿÿÿÿÿÿÂÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿøÿÿÿÿûÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿÕÿÿÿ‚ÿ‚ÿ¦ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿÐÿÿÿÿþÿ ÿÿÿÿÅÿGÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿÕÿÿÿ‚ÿ‚ÿ¦ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿÐÿÿÿÿøÿÿÿ¿ÿÿÿþÿÿÿÿøÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿóÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿÐÿÿÿÿøÿÿÿ¿ÿÿÿþÿÿÿÿéÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿäÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿÐÿÿÿÿøÿÿÿ¶ÿÿÿÿéÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿäÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ¾ÿÿÿ¶ÿÿÿÿéÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿäÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿÍÿ#ÿÿÿÿÿÿÿÿÿÿÿÿÅÿÿÿÿéÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿäÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿÍÿ#ÿÿÿÿÿÿÿÿÿÿÿÿ¤ÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿäÿû‚ÿ‚ÿŽÿøÔÿÿÿÿ‚ÿ‚ÿôÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿû‚ÿ‚ÿŽÿøÔÿÿÿÿ‚ÿ‚ÿôÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿû‚ÿ‚ÿŽÿøÔÿÿÿÿ‚ÿ‚ÿôÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿû‚ÿ‚ÿŽÿøÔÿÿÿÿ‚ÿ‚ÿôÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿû‚ÿ‚ÿŽÿøÔÿÿÿÿ‚ÿ‚ÿôÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿû‚ÿ‚ÿŽÿøãÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿêÿû‚ÿ‚ÿŽÿøãÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿêÿû‚ÿ‚ÿŽÿøãÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿêÿû‚ÿ‚ÿŽÿø×ÿ ÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÛÿû‚ÿ‚ÿŽÿø×ÿ ÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÛÿû‚ÿ‚ÿŽÿø×ÿ ÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÛÿû‚ÿ‚ÿŽÿøæÿ#ÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿäÿû‚ÿ‚ÿŽÿøæÿ#ÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿäÿû‚ÿ‚ÿŽÿø×ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÕÿû‚ÿ‚ÿŽÿø×ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÕÿû‚ÿ‚ÿŽÿø×ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÕÿû‚ÿ‚ÿŽÿø×ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÕÿû‚ÿ‚ÿŽÿø×ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÕÿû‚ÿ‚ÿŽÿøïÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÀÿû‚ÿ‚ÿŽÿøïÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÀÿû‚ÿ‚ÿŽÿøïÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÀÿû‚ÿÿûæÿìÝÿìòÿøïÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÀÿû‚ÿ“ÿþþÿûæÿïÚÿïïÿøïÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÀÿû‚ÿÿûéÿûÎÿûàÿøþÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÏÿû‚ÿÿûéÿþËÿþÝÿøþÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÏÿû‚ÿÿûìÿõÔÿõãÿøþÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÏÿû‚ÿÿûìÿïÚÿììÿøïÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÀÿû‚ÿÿûãÿò×ÿòïÿøïÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÀÿû‚ÿÿûÝÿøÑÿøïÿÝ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÀÿû‚ÿÿûÚÿøÑÿøòÿÝ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÀÿû‚ÿÿû×ÿûÎÿûòÿøïÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÀÿû‚ÿÿû×ÿûÎÿûòÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿÿû×ÿûÎÿûòÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿÿû×ÿûÎÿûòÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿÿû×ÿþËÿþïÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿÿûïÿûòÿûòÿûøÿûïÿþïÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿÿøòÿõûÿþìÿûøÿõûÿûìÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ–ÿéõÿòéÿûõÿòæÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿôÿû‚ÿ‚ÿôÿû‚ÿ‚ÿôÿø‚ÿ‚ÿôÿû‚ÿ‚ÿôÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿôÿû‚ÿ‚ÿôÿû‚ÿ‚ÿôÿø‚ÿ‚ÿôÿû‚ÿ‚ÿôÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿôÿû‚ÿ‚ÿôÿû‚ÿ‚ÿôÿø‚ÿ‚ÿôÿû‚ÿ‚ÿôÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿôÿû‚ÿ‚ÿôÿû‚ÿ‚ÿôÿø‚ÿ‚ÿôÿû‚ÿ‚ÿôÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿôÿû‚ÿ‚ÿôÿû‚ÿ‚ÿôÿø‚ÿ‚ÿôÿû‚ÿ‚ÿôÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿôÿû‚ÿ‚ÿôÿû‚ÿ‚ÿôÿø‚ÿ‚ÿôÿû‚ÿ‚ÿôÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿôÿû‚ÿ‚ÿôÿû‚ÿ‚ÿôÿø‚ÿ‚ÿôÿû‚ÿ‚ÿôÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿôÿû‚ÿ‚ÿôÿû‚ÿ‚ÿôÿø‚ÿ‚ÿôÿû‚ÿ‚ÿôÿû‚ÿ‚ÿŽÿø‚ÿ‚ÿôÿû‚ÿ‚ÿôÿû‚ÿ‚ÿôÿø‚ÿ‚ÿôÿû‚ÿ‚ÿôÿû‚ÿ‚ÿŽÿ‚‚‚‚‚‚‚‚‚‚–‚ÿ‚ÿŽÿ‚‚‚‚‚‚‚‚‚‚–‚ÿ‚ÿŽÿ‚‚‚‚‚‚‚‚‚‚–‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿø‚ÿ‚ÿôÿøãÿû‚ÿÃÿøãÿøãÿø‚ÿÆÿøãÿøãÿø‚ÿ·ÿþéÿøæÿø‚ÿ‚ÿ‚ÿ‚ÿ¥ÿþøÿû‚ÿ¢ÿûæÿûøÿûïÿûûÿû‚ÿÏÿìïÿûøÿûïÿûøÿû‚ÿÏÿïìÿþøÿûïÿûøÿû‚ÿÃÿøïÿûøÿûïÿþøÿû‚ÿÉÿïìÿõéÿò‚ÿ‚ÿÁÿûõÿû‚ÿ«ÿþþÿûéÿûòÿþòÿûõÿû‚ÿÕÿûõÿûòÿûòÿþòÿûòÿþ‚ÿÒÿþõÿøòÿûõÿûòÿþòÿþ‚ÿÃÿøòÿûõÿûòÿûõÿû‚ÿÏÿìòÿûõÿþïÿûøÿû‚ÿ‚ÿÄÿþòÿø‚ÿ¨ÿûéÿûòÿûõÿþòÿø‚ÿØÿþòÿøõÿûòÿûõÿûòÿû‚ÿØÿþòÿøòÿþòÿøøÿûòÿû‚ÿÉÿþþÿûòÿûòÿûõÿþòÿø‚ÿÒÿïïÿûõÿûõÿûòÿþ‚ÿ‚ÿÇÿûïÿû‚ÿ¨ÿûìÿûïÿûøÿûïÿû‚ÿÛÿþìÿûøÿøòÿûøÿøòÿû‚ÿØÿþïÿûõÿûïÿûûÿøòÿø‚ÿÌÿþþÿûõÿûïÿûøÿûïÿû‚ÿÕÿûãÿûòÿûõÿûòÿû‚ÿ‚ÿÊÿûïÿû‚ÿ¨ÿûìÿûïÿøûÿûïÿû‚ÿÛÿþìÿûøÿøòÿøûÿøòÿø‚ÿÆÿûøÿøïÿûûÿøòÿø‚ÿÏÿþûÿûõÿûïÿøûÿûïÿû‚ÿÕÿþàÿûïÿûûÿûïÿû‚ÿ‚ÿÊÿûïÿû‚ÿ¨ÿûìÿûìÿûûÿûïÿû‚ÿÃÿûøÿûìÿûûÿûìÿû‚ÿÉÿþòÿøïÿûûÿûìÿû‚ÿÒÿþøÿûõÿûìÿûûÿûïÿû‚ÿØÿòìÿøïÿûûÿûïÿø‚ÿ‚ÿÐÿøïÿø‚ÿ«ÿûìÿûìÿûþÿøïÿø‚ÿÆÿþõÿûìÿûûÿûìÿû‚ÿÌÿûòÿøïÿøþÿûìÿû‚ÿÕÿþõÿûõÿûìÿûþÿøïÿø‚ÿÛÿìòÿøïÿøþÿûìÿû‚ÿ‚ÿÐÿøïÿø‚ÿ«ÿûìÿûìÿûþÿøïÿø‚ÿÉÿûõÿûìÿûûÿûìÿû‚ÿÏÿõõÿøïÿøþÿûìÿû‚ÿÕÿþõÿûõÿûìÿûþÿøïÿø‚ÿÒÿòõÿøïÿøþÿûìÿû‚ÿ‚ÿÐÿøïÿø‚ÿ«ÿûìÿûìÿûþÿøïÿø‚ÿÉÿþòÿûìÿûûÿûìÿû‚ÿÌÿõøÿøïÿøþÿûìÿû‚ÿØÿþòÿûõÿûìÿûþÿøïÿø‚ÿÉÿûõÿøïÿøþÿûìÿû‚ÿ‚ÿÐÿøïÿø‚ÿ«ÿûìÿûìÿûþÿøïÿø‚ÿÌÿûòÿûìÿûûÿûìÿû‚ÿÆÿøûÿøïÿøþÿûìÿû‚ÿÛÿþïÿûõÿûìÿûþÿøïÿø‚ÿÆÿûøÿøïÿøþÿûìÿû‚ÿ‚ÿÍÿûïÿû‚ÿ¨ÿûìÿûìÿûûÿûïÿû‚ÿÌÿûïÿûìÿûûÿûìÿû‚ÿÆÿøûÿøïÿûûÿûìÿû‚ÿÛÿàûÿûìÿûûÿûïÿû‚ÿÃÿûøÿøïÿøþÿûìÿû‚ÿ‚ÿÍÿûïÿû‚ÿ¨ÿûìÿûìÿûûÿûïÿû‚ÿÌÿþìÿûìÿûûÿûìÿû‚ÿÃÿûûÿøïÿûûÿûìÿû‚ÿÛÿàûÿûìÿûûÿûïÿû‚ÿÃÿûøÿøïÿûûÿûìÿû‚ÿ‚ÿÍÿûïÿû‚ÿ¨ÿûìÿûïÿûøÿûïÿû‚ÿÏÿþéÿøòÿûøÿøòÿû‚ÿÀÿûøÿûïÿûûÿøòÿø‚ÿÆÿûõÿûïÿûøÿûïÿû‚ÿÃÿûøÿøïÿûûÿûïÿø‚ÿ‚ÿÍÿûòÿø‚ÿ¨ÿûéÿûòÿûøÿûòÿø‚ÿÒÿþãÿûòÿûõÿûòÿû‚ÿÀÿþõÿûòÿøøÿûòÿû‚ÿÃÿûòÿûòÿûøÿûòÿø‚ÿÃÿûõÿûïÿûûÿûïÿû‚ÿ‚ÿÇÿûõÿû‚ÿ¥ÿûéÿûòÿþòÿûõÿû‚ÿÒÿþìÿþøÿûòÿþòÿûòÿþ‚ÿÀÿûòÿûõÿûõÿûòÿþ‚ÿÀÿûòÿûõÿûòÿûõÿû‚ÿÀÿþòÿûòÿûõÿûòÿû‚ÿ‚ÿÄÿþøÿû‚ÿ¢ÿøéÿûøÿûïÿûûÿû‚ÿÒÿãõÿûøÿûïÿûøÿû‚ÿÕÿøøÿþéÿþøÿûïÿûøÿû‚ÿÀÿûïÿûøÿûïÿþøÿû‚ÿÕÿøõÿþìÿûõÿûõÿûòÿþ‚ÿ‚ÿ¾ÿõ‚ÿ¥ÿììÿòéÿõ‚ÿÒÿãïÿòéÿò‚ÿÒÿïãÿõéÿò‚ÿ½ÿûìÿõæÿõ‚ÿÒÿõøÿþéÿþøÿûïÿûøÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‰ÿõÝÿøãÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÔÿøûÿï‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÉÿòþÿé‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÉÿïøÿõ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÆÿõòÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÆÿøïÿõ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÉÿøïÿõ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÉÿøïÿõ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÉÿøïÿõ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÉÿøïÿõ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÉÿøïÿõ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÉÿøïÿõ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÉÿøïÿõ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÉÿøïÿõ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÉÿøïÿõ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÉÿøïÿõ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÉÿøïÿõ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÏÿïõÿï‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿéÿ€ endstream endobj 52 0 obj << /Type /XObject /Subtype /Image /Name /Ma0 /Filter [/RunLengthDecode] /Width 582 /Height 600 /ColorSpace /DeviceGray /BitsPerComponent 8 /Length 54 0 R >> stream ‚‚‚‚·‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ€ endstream endobj 59 0 obj << /Length 2857 /Filter /FlateDecode >> stream xÚ½YÝoÜ6÷_±}º5àUDR$Å÷ÐC’C.mÍMd‰öê¢>â$ýÍpH­´–íô’;°HjvHÎçoFñævoþ~ûçßöÏ^j¹1‘Q\mö7«HH¹Q&ŽŒà›}±ù}{w°½Üqo‡ƒ½ücÿg/S6ûU¢Ä$ÀÒ‘WD±àË#†÷»á@Ìò¶>¶mš¶7÷÷P‘Ñ"E©Œ4ð‘bšøÔ+'QªÅf7£ú¼Â+‰ ç›ÚQý{õ̉ЛÑÛXÆž›\ì)`3¹n…Q%|’0atϬë²O4ìlVô߯œt'#™H8*pžOÝ;‰K¾7R©ÍŒÈ© ®'j³SQš°§ÄŠäú[‹ƒhÒŠât¢ù+ˆù…MÄâÌ5bA;ÿZ¹°„›¢9‹xâ¥÷ÈŒY0Ó0g éð¢âfÁL)3—ÞÛ˜©•Mc¥ÔËýôRDF%(PÅþ'¢<3“«Þ€LÀ'´÷÷÷“ˆæ¦“¤—V¸°H'bœ9‚w)H_- kÁšE"Η²^—§4þsý´§¦OÉSÜ—çÂXL~Xa¸‰„ž³‰… Ì 6) ¤) x”ÆÞ—²¦XQ—ÔOêN8݉¯Ô]²¢;IºÓ_©»ä1Ý¡§/twÈúSpƒ>«ý¨¶YS6·>~zº²¡ç‹÷ œÄJ<¢»€ÿk¥!вÈÈ”¶ù ~%b½}õ†žyVåc• eÛôW°Ä9Fåj׳ÜÉû1k†r(mÿ–sÝùÖñ "N·ù!ë.Yº½µ»Â6}9|¢÷EÙ]y}ÉãíèøãϳÎsû1«ªOtR”‹ðõ¤³ÇÎö%m?é¶½dD ÿl‡+f+žÓ›Û®,zZº;´½¥Õ¾üìG¥™ÑôÆ^r¹½£µ¡¬mOëU¸†g?²†Þ8•à ëëðó6®½zØ7þ¤9ü¯/o”·Í¡Ö 0‘ð`·háJŸ–«‡±):ë.«n'x‡vìaOtlËfð$Ä.íîæ¥”UôTU¶¹u&„TÙñX•9)ŒG2¾ý‘H‹²³ù°vzÏþeÕè~ Vgèpø$³5 ×ÛËÛ6½_™¬énº¶¦Ñ‹÷¸y,7Ýùpá^Þ]2€FcUд³ïÇÒ¡1˜d=m†¦ˆ£Ÿ³&ÿÜö´]?ØãZBPyÎbõ™SÖ*øØ„‘+˜6KqÜ´hBùCàÍFN3+XCÆMÍl::>²:j»ìÖO@Þ÷ï&MÄÓ) =Œ ªÿA°âò'n´>•n÷᪇1Ü3«Û!²’Öj[·Ý'{‹ðŸ™‹#ÌÞá‚%2ŠC@䨂t]X{²þÊúØeù®Qùt+üÚ~ •s×Óí±N{°?“Ä…dKgÚ9st+Ç®Ím1ºˆÌ{b>öîn; Î Ï÷Ç57|Ǽs‡‘3³Ç 8îØõÎ/qJAlÑvp¶š¢(¸iKÏöÚÇ"©Cx»Ç"oí Få M%fZ hp¡iH Âš¼´©îƒ ®‚¦3VÉ:šÀ8«mÖ+­î¼ºZÙª<ÆgÛÉÕíþ>±@à;ßÍÿ™0Û#ÅÌÅZ/uÙ!Övc úi¼}I‘Q Ku2Q\áÔ„uA¬ß6 ×5©²TGâé¾[¹€‰T<ÉÝ…pà A , ÷Æ,æ–¯ý¦……×uÙ )!»2¾{'þä+ÒPD0óÿÓ3Ê3е<÷Ǯޠ¦´­ Ù|Í9ÄYžþy߸z¬bNG|¢à©îVxéHö5=€‡‹‚ïVanš>Þ(=œ @ÔYÌ]‚%™8HçÖff¿èËõb yë:N $#vs|»a1`âs²~˜¦ÁMLpÇCx†…ï&è{Ürº‘YÜÏn¤ÞW-7`ñ”Y{ P²X+c¨K&qÏ@sç#‘. /¡éöµƒ‹.3hœaižD`JÁN#Æn\•kMPµÖØ13\œsC–_bÈòICÖO²\²“„Kæ ‰wþþ^†„rƒ(”3B—âé"Ðz› 0¬ÙtÄ•¼_9Ì+)P©¢„xò0VJ0ÑìD@(\‡…~¬qììžg¸ÞÒ/œÛ¥<4Ç _QÔ¿+± ˆ ‘)¹š24IE¢#–<ŠMg}ÉGT)]jFô­"pp @ç h6‘Ä¡B~Jn/ÆS(A i¯+[/ë*‹µÜÇÜö}y*íˆ>Àa${¿XúÓfh-ð_[¶¸Z“YumK߆Ά³öñ+s» ³™oLPüqãSqýÜ)¸Ž„¢í¼À_ÄZ±}YÞF4âô¸³ô,«j쇎lÒ$ANÝ!·Ç&$'±ˆÃb‡{Ï´tíwÀðëîWžž¤œÛŒ×¶ùÜ–ùƒÝŠ,ÇÚj¯Û ¤PYôŸXReƒë³óÁl‘'Dâ»?ðâÚÚÆ“´õq¤t3J‡0ép»º£ìºo»£Àùh¡ò?qæéÁ™V‹üß‚§Ï3pæõi+D£ ŸPcn+oǶʺòsHÞYÕ†<ÙÓi)ûXö÷¿}P§k’œnú`óbÁ`o؆ñÄù.×:’ŠòúâýE ¡N#÷"üÊ/<û©æ›çíÅ/ð71ÔI¤\¯îϲç¬Ðÿ M€iÌN>6iw1›lâ2˜òÍgðWò”où÷˜’í¯'“Õ…ÉÀÜÉž=‚…Ò™#Œ‚@¯<Þp:M™—8œÌ©ÉŒÃÜŒ`îÍßxZ4!7°¿]2n¶Íö1`†a쮳²6ÐKyd Ä7ù¸æ“ᜊ ¾=-yÃÑ|*Y&¢pOZFS÷&d`o¹¤ï»òöà—Ê&p ¼Q"¨ ߟÀL½…—/ê‰ð˜5¶êéEøÇ]ÃS·Gš(íôV„‰C*ì\$áÛI ¦A‘Õ•‚³P¹²ô“³v pÅO”á{f—ÑÀë¹íó® ºuþ]ÜlÏquQâ…?”ň=ýÛ›áŽLÑž}ÐìW+M,y™ÐbÚ ÀE¢o`Só L§Ý?þr¿¤ëü‡ ª-b)W‰¶/o]Š«®©ŠOzY·…³\¢.ž ^xû‹Ç'zñ=BDZLû—4Ü c½Á¶Ê I¾xýêׯ_ÿ“69oˆ‡6}ÊÝ—ŠE$þ [<¤@ñ`$=M,7ÔaÂf«ùÖ²»1L©‹K­2˜Ž«fDH~ŽoÛ«Ä­g9Q®IDÄ19ùR‰˜SÓe’ˆ/F’Hµ¼úÐYÌžŠë훃u½(ʆeE],B¥½µ4ym󈈤Ï^‚Ͱnd®8YÙuÙ<[«Ÿ<Ñ\@°]éOä=jU@Ì€ó/•+œ½’ÜõS@‘wf-¨|×MÛªlÞù¡ëõñ tPŽ ù8d6û5¯ŠÔ,<Ñ…Hç<È%œêH!?FCªûýxSÀKˆg ÕtsçHk(®˜@D^m^C¶t q±!—*RYA" ûŠ€eôqÍÿãˆ6ÿÒ8]‘2ŽMßvYík5.N›éD?qÙ””hó-.›åzW‹ËNÀgñ|qíKð:[êž±s¬ô1Âö endstream endobj 55 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (./Benzoic_acid_1new.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 60 0 R /BBox [0 0 1551 1253] /Resources << /ProcSet [ /PDF /ImageC ] /ExtGState << /R7 61 0 R >>/XObject << /R8 62 0 R >>>> /Length 76 /Filter /FlateDecode >> stream xœ+T0Ð340572S0AdNr.—~¹Bz1W¡‚¡‰™™ž)XÜÐÐÂÄPÏRÁPÏÌØÂÄ B›™CÔ[(¸äsr(¤I†Á endstream endobj 62 0 obj << /Subtype /Image /ColorSpace /DeviceRGB /Width 1550 /Height 1252 /BitsPerComponent 8 /Filter /DCTDecode /Length 253907 >> stream ÿØÿîAdobedÿÛC       ÿÛC  ÿÀäÿÄ ÿĵ}!1AQa"q2‘¡#B±ÁRÑð$3br‚ %&'()*456789:CDEFGHIJSTUVWXYZcdefghijstuvwxyzƒ„…†‡ˆ‰Š’“”•–—˜™š¢£¤¥¦§¨©ª²³´µ¶·¸¹ºÂÃÄÅÆÇÈÉÊÒÓÔÕÖרÙÚáâãäåæçèéêñòóôõö÷øùúÿÄ ÿĵw!1AQaq"2B‘¡±Á #3RðbrÑ $4á%ñ&'()*56789:CDEFGHIJSTUVWXYZcdefghijstuvwxyz‚ƒ„…†‡ˆ‰Š’“”•–—˜™š¢£¤¥¦§¨©ª²³´µ¶·¸¹ºÂÃÄÅÆÇÈÉÊÒÓÔÕÖרÙÚâãäåæçèéêòóôõö÷øùúÿÚ ?ýü € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( €>lø•ûWüøg¨6‹w¬Ï®ø‚)Œ7g†‘.ä³!¤GóœºÄŒFˆ¿š¥—)ƒšïÃe¸ŒR¼U—wýÀ>O:ã\£"—³­SžkxÂÍ­÷Õ%kj›æÛK©þßÖ˪]Cáÿ„·—z*íònõ-],ç“å·ÂÊ«†Ü$l€Àô©ðýI/~v~—ýQñX¯ðt¦Ö åÉEýÊ2ëæÿCǼQûd|sñ›ýá‹avÓC.Ÿf.®<˜,2½ÆøÛ†Rα!,€ •=ôr øÛ—à¿ó>G1ñs4¯xᣠJú4¹¥nÍÊéùµ·M‡hŸ¶ÇÝÆ[{ét zw”È·z¾œRHÔª€[<)´O*[,yƺœ?‡“¼n½ùÜçÁx½œPƒ…^JŽûÊ6~žãŠ·Êþg¯xöó‘eÒíücð¾hà}¨hš€•ŒZ+i@Vp>V›*§ï9ùõxzjîœý.¿_ø×àQi¦z?Â?þ \‹mïûWÂMµdðî©4Kæ™ÛÑämÒüÀ%÷:9UÇŽÊ)bõÚ]×ëßúÔý'…|EÌ2©ßÚQþI7e­ß/ò·wÝkwÒ?G>þÓ¾-ÜÚè6ïq£xÞH™Î…¨Že(ŠÒy‡É*‚ÏòÈV7s¨&¾K–WÁÞRWuúöü¼Ïè.㌯‰yiQ—%f¾ o¢Mò½¤–½¥dß*GÑ5çŸbP@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@ˆŸ¶‡í âO|IñOÂë·|2ÐfŠÂóO„MKQ·w3<„ƲmI[ÊòËÝù~^‡ï\!â}XòáswÏ?ÚŠµµI{ëfßÅ»÷‘úc}eªYYêZmäzuÜI=½Õ´‹$sÆÀ2º:’H ‚9¯—iÅÙî~íN¤*ÁT¦Ó‹WMjš{4ú¦Z¤XP@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@ó'íyñ–ÿàwÁx³@Ô-ìüc{<V‹%Õ³\/Úel¹ ‚¡’Ý.%S'ɺ% ;£ IVª¢öêxÙöa,·:Ôݦ죥õä®õÓO‘üóhS¬b5O`}m'cùó+¶{1U\Ÿ˜õ5ßMŸ#Œ…ÙéÚTê»N '»WlóX¨6w³©šé‹¢9&"ÿt´k/¨üTÆXþÕŸ¬uyuÏøgPÒWwm§%ͤÒ|§nÙZYUpÛIÊ6@#ŒäwZ?í¡¦¶ÿÂ_ðËZÓ‚lò‘u¡æýíÛüÁÌaqÙÉéŽ@=Çá§Çÿ†ž;Yk?6âC¬*Û]œy‡ä\•—䉜ùLûTÛIÅ{MP@P@P@P@P@P@P@P@P@P@P@PKûû*Æ÷TÕ/`³Ó,â{‹‹»©(­â@YÝ݈ ª ’IÀ“M''e¹3œiEÎnÑZ¶ôI.¬óuøéðIþçÆ/·ÓÄ6GÿjVßU¯ÿ>ßÜÏ1ç¹RßOÿù’ŸOO‹ž ?M~ÏÿŽSú¦#þ}Ëîd¬9GýRÿÁÿ3ñƒöøø»§üvñÇÃË_†Ò.±àŸésH5±¹´˜^Üˉ£q8BQc¶µeÚƒ—|³t__‚­E7(Ù³ó¾)⌳0•8Ь¥§ÑîýW’>Oм+©[²Ët@?ÝUn?+Ù¥BKV~gŽÍ(Ô\°ýQ°´xB†$Ší„l|Ízªz£³°} bºbϼnuÖ“&·‹<š°GCm88Ö©ž}Höó V©œ i$§Ö­3žQ,¬€õª¹“ðE!ÄÎRÑÑ Xæï``GŒ‘èÑ™æÚî˜$ŽQ·*zŒWX\ú,%Å­OÓ/Ù+ö‹´ñÎcðÃÆÚÄïñ+M‰Å½Þ£*³k¶êYƒ#àš8ð®­—eO7sŸ7gÃæ¹{ÃMÔ‚÷áÿþ±ýMÀ\_ ç *í[¿¶—Tÿ™-z´¹®ýë}¹^Aú0P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@;|_øõmà+ïøD¼+§A­xÝ¢/ÔÞø;ö•ø¹ð¹ÖË_˜øÃéŸô}^fqÿ¬o’ï Ç.êOš$ùP*ìÐÝŸ h_†_¦¼Ó|'ª\Aâ[8>Ós j°ùpÃæÄ€RDÈRLNá<ØÃìg @ß@P@P@P@P@P@P@P@P@P@ÆxÏâ'~Y ÿø·KÑax¦š$¿¹Xå¹X€2bÎùX_–5f%”IëJJÎÔâÙÃŽÌðyd9ñ•cfÕÚMÛ{-ÛòI½»Ÿ3ëß·_Àý&ú+M*?x‚ÝâÝ#MÄŒK,‹—…÷áJá‡$äBžMŠš»Iz¿ò¹ñØ¿²,,Ôa)TVÞ1ÓÓÞqwù[Ìñ~ߺíÌ:¥·‚þÅo?šEŽ£­_´Êb0ÒÛF‹†dåYˆV?yÀ纖@ÝIúÙ~¿ð•Çx»©Ç ‡IßÝr•ô¿X¤µk¢–«¶¾A¬þÖß´n½}冽§hëŒØé:\°f&BnDϸ†€ápƒ“èRȰñ^òoÕÿ•‘Æø¯œÖš•*‘¦»F)§çïs?ÆÞG+¯|xý¡|Qgާñ3VŠ¥ÒV2BÁYpÒ[$nˆ?!%IÁÆ@#¢žO†ƒº§÷ëùž6/ÄŒïgSÒßÝJïŠNÞW±æ~!—Åþ5m=ügâ-__kÿemjö[Ãm¿nÿ/ÌfÛ»bgÎÑž‚ºéà©Sø —¢GÏã8£Ibq¶æ”½.Ì…ð¬j?ãÙ~EoìcËy£hxm­ªãýÑG±·B^bßÚ&OÄ?倅?d»ñòþaN‡ÿ˨ýš®Éõº:Œmü¨öbx·Ô˜idv§ÈCÄ“%˜C¸>ÔùlC­sFdïǽZG<Úf¤2ŽjÓ9g›6÷cšÑ3Ž¥3b+¡ÆkDÎIÓ4c˜üU&sÊ ïpjˆ± £#¯4™qÑ™I¸ÎHë¤ìÎGP€Ù®y£ÕÃÎÌóåÕµÿkºoм)ªM¦x‹L—ϵ¾·#tm‚ ‚H%YXeb¬$W›Š¡±pšºgÛdY|¾¼1y¸Î/F¿­žÍ=Ñè~ò|-øƒ¦|Tø}áoé1mu{o1íŽóöiÕŒsC¹‘ ì•$Mû@m»—‚ |zN…IS—Cúï*Ì)æ¸*XÚ[M^ÝŸU{+ÙÝ^Ýþ²= € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € (æŽÂ//ü,W?¸ŒîJ‰"Ðâa‘$€ä4ì1Äx‡q·jÈó„|"Ážiž[‹¹äi§º¸s$·±ÜòHç%™‰$±9$нéˆô î×ÃÙUýßé@'ÃØ_õ¥f]h!Tüœý(ŒÔ´!‰Jó-oA8 @+âO ¥ÂH¯>¸ œu}#_𖿦x¯ÂšÎ“â&o´Øêv˜[É‚ÊÊYYufVIõsömý¤´Ž:<ÚN­ ¾“ñGI„>©¢FÄGqBý®Óq% f $´LÁc’P§¨ € ( € ( € ( € ( € ( € ( € ( € ( €p¥‹0½j9.—Ù»ó×þùöeânyºöî½Ò‡»o+¯y¥}›}/w©ãö±ƒ-}FkÔŽ+¡ðUóz³ÞGOãôö­•$y²ÇIõ4bÑTcäâ­S9åŒ}Í(´„ÁV©œÒžäãIQüùúÛîJºbÿvŸ!/û’-HûŸ„}e÷ýšoÒŽAý`œ§·éG }a>˜ÐRp4X—Ü®úRv^ir,K+>ÇÝ©p4Ž ªÖ=ŠÒå5UÆ}—oÿ^—(ý­Ä1íE‡ÍrÄy¦g"ôrZ³ D½ÅO^=*“1”.h$üj®s¸3c½%ÊÓ8 ûÒfG?xŠÁ…e$wÑ“GžkVÛƒds\µô:–>Çý€~ Ûèþ!ñ·Â}OPò×VÙ¬éî!DyÑ|»¥V$Hò4KnÁàÞFùpw|Žy‡k–²^Oô?¡¼,Ε\º¤·÷¢´Ýi/6Ú³¶º&ôëú›_<~ÆP@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@÷‹|O¥x/ÃZ׊µ¹Jiše»O VEyHû±¦öU2;DRFæeèógë«ø›WÔ¼OâëšÅË]Ý]•¦òÌ#EÚˆ¤ª v ¥|;¢¢¤` Í{¢‚ æßI†%‡>ÔlØ[‘´“y¤#)eŠàµ]+¾Zó-cM\8+@9¯éÀoÂP‚x·HÅ/ËÈ #ðßÃMÅ:ޱ&¯oæ‹EcŒ¨*w–É>ã`üÍ}_ `éâgVsû)/¾ÿä~ãÏã2l. …²UeRMë{ÓQI.–~ÑßMÒ³Zßb÷àV‡mwc©è(Ún­c2\ÚÞY±†ki‘ƒ$‘È¿2º°0 ‚õurª5¬?eþ fXJŠn£ºës®ðçÄÚƒálâMâE爴¡<—2i~2Ý«G;<~Xwo´¢.Õ#™2䃹Ãxxž§-`­è~¥‘ø×Œ¢Ôqç_Þ×ñßñ>€ð÷ü´6añcá³o¨ÛA‹¯O ìw²í>sy3¼-î Q<ÉŽ‚ß.[ÁÄd8ŠZÇT~·”ø±”cÒdã-6Õyïk~'Úÿ ~/ü4ø¿¥Ï«|8ñ†µoo´Á h®lòò"ùöÒ–Æ)6ùˆ»Âî\ŽkÇ©JtŸ,Õ™úF†Ì)ûL5E%åú­×ÌôšÌë ( € ( € ( € ( € ( € ( € ( €>6ø¹ûf|:ðmž¡¤ü>¼‡Å¾31nöÍÓm¤! ´× ÀH¸°–$ÆÈÍ;‡­„Êkbs\±ü~ïóüOÏø‡Ä<³(„©ádªÖ¶–Ö ék˪×hßTÓqÜüöñ—Æ¿Ÿ Ì&ñÝü<ÿiC¤iì6Æ ¸xbÁš0£h\òK1?I‡ÊpôlÔnû½á¾GâYψ9¾gÍ×qƒ¿»uYîµjÚ{ÍéêÎMðÜ OjõaE#à19Œç»;+]¶ŒGŠè3È«ŒWÜÚƒGÆ2+ELâž,Ö‡JVŠ,ñW4“Møjùg‰ó-&ž?¹M@ÎUËi`{-R‰“®H,ˆíO”Ÿl;ìGû´r‹Û l¿Ùý(å¬FlíG)J¹±ö¹F«Üì÷i8šF±QíÏ<¦ª©]íqÚ“‰¢ªS’ÙHÝa…N94¡@x4Íjö€† phÊu›Uùø ×íÅx‡ˆm‰‰ðïLO·xªdþãÿjWÙðŒù=¿ý»ÿ·ÌÿH¬;Äe[§¶ÿÜG£Ï¦¯?%}¼j&.ÕÁÎw:,Rg*j­sóU§ÐãõÚ^ÆÑÍn®¤¨Íx\έ ^.Ìð=oáDún«‰}Ôñy à•H×%ˆ2:òÜ.æR+¯ ‚­‹»Zwè|ö{ÅoÅïUÿ„wÁ³ïOì š?:&ómÌÿ~lÇ.Ç_–&Ú– }V'¥BÒjòîÿNߟ™øx‘˜fÊT©ËÙÒw÷c¥Ö¿ÞWNÍikòž]¤øn(B½ÊtR?,Åf2žìímth׌WLiž5\dŸS¡¶ÒÀƵP<ú˜—Ü݇OP¢Å:í—㱕j'<«YÑj”L%Y²êÙûUXÅÕ&[1éO”—T°–£ÒŸ)›¨?ì€ÿ >Q{Pû(ÃG({@6£­¡íšÔzR±J¡µ”¬W´!{_jV-T*½°î´¹MFR’ÔsÅK‰´j™ÒZ{T8ªQ’ØsÅK‰¼jÒÛuâ¡£¢ é #”åZʯÏ@C®Æzñ?E÷ø  _ t©f¹ñ%ÃBÂÐ*ÈWåfa Pr=Ç­}?ÍÒWÑÛõÿ3ðÏ0ÐÆÕÀSºæŠ¨Úê“ä³·gÊíÞϱêWZF3…¯ª§‰?ÅäÖÙW:p@~^k®®|ö+,P[ÝÕ™ç*k¶.|Æ'âïcŒÔôÂû€^´ç®Äáß&²8»ÿ -Ìn³ÀXf±t¹·= y‡²’äv<3^ø]w§jpø“Áº¾£ xš×y·Ôô‹™-. ,Œ²XÈeʳ)Á GBkÉÅåtë&¬~ƒÃ¼w‹Ë*FJoN©Øúßá?íѯè7¶Þý¢ôHaÓã…ÀñÖ‰o+ÉmV1£¶ée&X0¡ž5¢îuøìnIVƒnž«±ý'Ã(`sXÆž5¨Kùº|ןu§’Géâ/ø¯Iµ×ü-®éúÆ…u¼A¨éWQÝA6Ç(Û$BU°êÊpx*GQ^¢âí%f~¥J­:ðU)IJ/f×ÞŠF@P@P@P@P@PKûû *Â÷TÕ/`³Ó,á{‹›»©(­âE,îîÄUPI$àI¦““²Ü™Î4âç7dµmè’]Yù«ñöã¹Õ¤›Ãƒ%·îøÒîߺ´‘[ÚOÀ¦YGüô Ü–½üJê{õöíÿü‡ŠüL†<>Rï-=ö¾ô¢×¢»óÓf|Ii¥Ïsqsq5Ö£w+Ü\]\ÈÒËq+’ÎîìIff$–$’I&¾²•ÓŠŠVGóæašUÅT•Z²r“wmêÛ}YÙØi@c ÅuÆÏ×Å_©×Ziê q]äÕÄ6oCgÓ Z(œ3¬kÁfxùkE’uhl‰е–U‹ÑÙcµR‰Œª—RÐUr™:¬²¶ê;S±››%¯¥192_%Gnh"ìw”ž”Âì<•=¨°s00/¥;3#6ÀÒ°ÔÈš×®)r”ªžÜŽÔ¬Z¨Tx=ªZ5S)¼Õ65S)K犖£32[~¼T4t¡,=x©hèŒÌÙ¡éPÑÑ ™CŒñY´uÂft±u¨h茊/Áæ¤ÝÝé6h‘“w¥rÔJ’Ì}j[5Œ K¹s»šÎLí¥ˆÖ0èÞ¸®j‡µ„÷Z?H¿à›¾#Óæð?ÅÅopº¦™®ÇªÍ3*ˆž+«tŠ0§9, Œ¥PdÁ9!~?8ƒU”»¯Ëþþðß™uJ=c+ü¤’_úK?H+È?D ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € (ò:IãOŠ£Nü$ú¡?_µË@GøJ|¬c=¨Þô…]œÐ¬ØN%…Fyz€ :rhÕnFgŠòíb`ws@8|Qø™à‡6FûÇ>0ÒtHd†i¡MBé#–ébÈ ‹;æ`~XÕ˜–P$© jòv:pØ›Á˜Úëš»P_{ýâÎWÁßðRð¤Wøø.n®äVyÿá&1üŠ>UÛöB8%ÎÚöׂâ8àã$©]¾¼ßðžâ_ëñ-js–?’M(û+êÞ®üéê’Véo6pž0ÿ‚ŽüyñZÍŸ‡4Ÿ xjÚâbÖwv¶r]ÞYD$ ª^i`ØÌ`努m+qv2IªJ1¾Î×kïÓðûƒ.ú;ðå Ó©©V³KÞ‹’Œ$ífí¦•õITÓDÜ•ïâVßµ÷í3kªë:Ì5¼Õ<Ÿ>;‹;9 O-J¯“Äbƒ üÞR¦óËn<×8—2§'5YÝÛ¢kNÉ«/•¯ÔúlO‚<‹¡OS.-;Ù©N2|Îïšq’”ü¹Ü¹V‘²Ð·'í—ûNÉ÷¾&“ÿp]3ÿ‘ë¡qvl¶­ÿ’Çü"§Ñ×ÃÚŸ[ÿ•kÿò£þØ´£rßI?öÓù´\gœ¯ùÿ’Ãÿ‘8çôiðÚZ¼¯ÿ+b?ùiÓh_·ÇÆkMIü;¯Îò™毦˜äE €[<)´O*[,yÆïÃqîiF<µ9fûµ¯§ºâ¿ ùŸ'œý81®«a}¾%nZu/îß3u£VWwIÚJ6JÑNí÷¶?·¾°tËx|EðªÂóY¼ë­7U{8dù‰]°¼R²ávƒ™$Æp=Z^!K‘*ØtåÕ©Y}ÍKógÀ㾇”V*S˳™BŽœ±RKE{Î5)'wv­Ù4µjï¶oÚÛà‡ˆob°Ô4ïé¶’îÝ}©XDñE…$nË$œÚ‡’3’=Hq–Uˆš„”¢ŸV•¿ßà|#è×ÇÙ>XŠ¡ZQµ¡N¤”¥v–Ž¥:pÑjï5¢v»²}?þ$Zèú¬^$ýž¾2Ťø‹SÞ³¬î‘$¾òÖeýþŸ8ÄÛæeób;s½qÃV“Ž[›%ì*FMÞÊö–›èí.¶×c“ W|?OíLjTéòóO•Ê—½k^¤y©?‰-$í'ˤ´?B>ÿÁ@,ï57Â<1†µK¹Å¼~)ÒXÿenfƒs¬dµ@ ¿|ÊY™ÜŠHùü^SWwWâ~¿ÃÞ às…W´&úýŸÇnû»#ôcMÔ´ígN°Õô‹ûkí&ú¹µ½³•f†æPÉ$n¤«#)0$Aå4Ó³?@Œ”Ò”]Ó.ÒP@P@P@P@P?â¯xwÁÕ¼WâÍZ 7ÃÚl^uÍåÁ;Qr –fbª¨ ³3PIÜ!*’P‚»g>+GFXŒD”avßõ÷-ÛÑj~'|rý |iñÿÄWvö×7ú?ÂøsgáÔ˜ »@êâkЧl²–)Ü‘m2wÉ'Öåùdh%)+Ë¿ùÏaÇUóYÊ•áGeïç+nô½¶]5»|&£,JЉzú tì~C‹Æ96Û=ÃL)+“]Qóõñ-³ªµ±/¼by•k­È­cÏ«XÚŠÐv´Hã•SR^œU¨œÒ¨iÇjsV‘ƒ©ruƒ”ìO1(ŒRØí‹@õ&: öP ”Áƒ@¬4„§qX1šwÆ@hÜ ïî*JL©$Ò•#6gÉ^*Z7ŒÌùmÆ FfTÐuâ¡£ª2f‡¯ P™—<8ÍCGT&cÏ3Y´uÂFDéÖ³g\$eËÀÅC:bP’Ldf¥³¢1¹FYT6m˜×Rpj$ÎÊQ8íNCµ«šlõðÑÔûþ ÏâmB×âÇÄ_Å ±Òµ]59åeo5fµ¸H£ w`)[Ù·¤’©‚0Aù¬ê Æ3ìí÷ÿøxg^Q­[ÒQOÿvÿÛ™û_>~¾P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@PäÿÄ»=7Ãÿ´/Äí/LƒÈµ’îÆMìùšâÞ+‰[,Iù¥•Ûìz·…õ¢0 {¾‰~C»Šõ/TÀ_š€;u¤Q¸ÐƒyÝ@—‹Ñ©ê×qÚ[Á¹Õ|²«—eQ“É`:šR’Š»vEÓ¥:ÒP§)>‰]ýÇä—Æ¯ø*·4‹›½௄.|[7“*¯ˆuv“M²Žc dóçEvq"8·?»Â± yÕ³*pÒ çÙeÜ‹ÄÚX—È»nüü—–þ}Ë?þÕÿ´wÄO\ø‡Sø³â+~å‹LðÍüÚU¥´EÝÖ5Š]Ûw•!y ª†vÀ¯.¦>¬Ýù­è}Þ„°x({%/9$Ûûÿ%eä|ïНEé\rªÙôt°ŽÈ¶-WÒ³ö‡bÂEt$ãÒ“™¢Â®Ä‚ÜÒ§œÕa’èHô£œ>®„ò £œ_WCM¸ô¦¦L°ë±®s)a—bj¾•\ìÂXDúžÐzUª‡-Le lU³•­£U£Ï­—Æ[£Ñôß‹ôÁå]kòk6EÚG¶×A»ó ]¼ÊÇÍ`ªàdtäçÞÃq&:Ž’Ÿ:í-þIþ§äÙß‚¼-™Þtp«RÉ)QýÝ’wøöm½Srƒvv¾‘·Ô³çí¯ãŸ‚óÜÛø?S¶Ñ¡Ô'š³ »Ñõ ,D$ଶîKn%F$‘ÕBׯK3Áæ6U—$ûô{ué­÷Ñ.§ç˜îâ^r©–KëXm_+_¼KÞ{m;%x5)ÉÙS²?¡/ÙûöŸøoûBiÇ÷Ÿ`ñ¤Vßj>º%¤µFb…á›hK˜wm"X³…–-ë8JŠØyгzÅìú3|³8ÃfjPƒå©%¤¢Ó³M;=·[=£«Ö ( € ( € ( € (  —÷ö:U^Ág¦YÄ÷wR,Q[Ä€³;»UA$“€&šNNËrg8Ò‹œÝ¢µmè’][?ÿioŽ ñÿÇ–Þ¼Ôáv†6XZOû¸õ\=ñ‹ha¹X" e@H™dJúÜ«.öçŸÄÿ#ù߸Åfµ¾¯…“ö0ÛûÏù­ø$õK]hóM+JHÕ>OÀv¯£§ Œâ±NOsÐ4í<|¿/Õ#v6¶ À®…È©Væýµ¯N+U‚¥CzÞØ qZ$qN¡«cŠ´ŽiNåäR: fl°)Ü›Úi¢8 QƒéJår†ÓEÇÊ.ÓEÇÊMPÚh¸¹DÁ¢àâ&=i“Ê4¯¥ØB M Œõ§rH^>¤PÐÓ±JH³È¤h¤P–,v©hÚ23e‡¯ ÆFTðŽH TæbÏ^+6ŽÈHÇžçŽk6Žºs0î#Æk&Žêr¹‡r¸ÍfÎÚlĸèk6vÓ1§®k6vB70îg#w5“gm8¾£ elu¬&ÏO3èØ+DÔuoÚVÞþÏ^¸Óí´múúîÒÛuX˜Çn “ Ñ%ÄSòn·^3†_8iRµ·gëþS”ó%+(Å·ç²³ù´ýQûŸ_6~ÔP@P@P@P@P@P@P@P@P@xPý¨¿ffû¿´WÃôñv›ÿÇ«?kM}¥÷‹/ÅËj2ÿÀ_ù5ªÁFc#TÔt‹¯vò]ØÏ%´²Yhº­Ü,èÅIŽx­š9S áãfF*H ÖoEhäuÃ!Ìf“T^½Ú_›<ãÆ¿ðUoÙ+ÂßÙŸØZ·Šdr$`4L¯(,«æâs(S÷iêÿø'Úä܈Ưk½8öûOOŸ/Í7º²ÜüPñ׎üuñOÄ—>.ø‹â­KÄ!›rý¯RœÈaŒÈòyP¯ÝŠ òHV(¢î!T+Ä«ˆGy;Ÿ¨à2|> (¯/×»óg9GÌçsÛ§‡QZ"ÂÃíPätÆ:Äj‡#¢4’$z \ÆŠñô¥rÕ1ÞQ¥qû0ò>`öbyGÒŽ`öc ~Ô\‡LŒÇUÌC¤0ÇNæN™ F=*”ŒeH®ñÚ­HæÊϵZ‘ËRF[ps‘[FgŸW ž¾ñWŠüu÷…5ûÍ6îÞe¹‚KgÁ·YYf?rU1¡.m5èá³F8Ó–¦ëîwWóÜøÌó‚òŒî¤+âè'R´“qšµì¹âã.TÛ|·å¾¶¾§éìÇÿ?ø‰ðêþßÃMÿŒ§œ‘ßJG=pA“G}6s·K·p¬dzÎné°HïXÈôi#˜¼“«3Ó¥“¿¸Â·5„ÙêЧ©õÿü¢@ÿ´ŠÏýJ7ú[c^pïIzþŒýsÈÛSüÿJ‰û__<~ÄP@P@P@P@P@P@P@P@x¿ÅÚ+àwÀëy¥ø«ñ?BðýÜpEt4©î<íBhd”Â’Eek‰P¸`Y#`698ÄDêF:pøJø§j0oòûö?(¾*ÿÁdl~Ï5—ÀÏ„RÝIM³ãÉÖ$·›Í>b5«±•< 6¸¹Œ‡~T„ÃñÔÇÅ|(úL' V¨ï^V]—ù¿ò><ñwüöÄñF©o¨hÞ.м%iºÂÚo‡´i`•Ã12±½[‰7ÁH¸PwäžaQí¡ïáøGi§/WþV>-ñ—Ä?‰²ÿác|Dñ?Š¿³|ϱÿÂI«Üê?dó6ùžWœí³w–›¶ã;=rO)üNçÐáòzáAFý’8å´µbê\ôa‚H°¶«ýÚ‡PèŽ v$£ÓŠ^Ñ›,"ì?ìÃÒ—9K »û0î)s²þªŸA ¨þíÐO» 6jz­?hÉx8¾‡Káø×áî§>·ðÿÆ:ç†u™àkYoü=¨Ï§Í$%•Œm$L¬P²#'¢žÂ´†"pÖ.Ç&#'ÃâW-ZjKÍ\úÓá·ü7öµømý‹j>$·Št;Îÿ‰_ŒmcÔ~׿o?¿»ÂÞ>Ö“rÿ¤ lUûƒeuC1­·õ< Wåø‹µúÅÛî[~‰ú5ð—þ ïà=_ìgƇ:Ÿ‡o›ìvòk~”j6m#en.%öM(vº¢™ –3(ßÝK4„´¨­ý]Ï–Çp.&•儨¤µÑèü•õMù¾Uú}ùð÷ö»ý™þ)}–?|hðÌ××W˦ÛiºÉÒï.î[fĆÖèE4»ŒˆªQfÊ‚X;a‰£Sá’>c’f+ûj2I+¶•Ò^m]/¼ú6·<° € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( €<'öŽø_7Å…zÖ‡¦DÒxŸNeÕttVÇ™w¶"Á–4̱¼°ƒ#lC(‚PPå—ÃïA=«¥Â¼R(dt`C2=Á £4Moîü}hãíáO^ëîo5k€ÑiZ›SœÀ8;#\©yH!A32#c^¼hGšG§•åUójÞÊŠÑnú%þ}—_Kµøµñßö’ø›ûBêŒ|W¨}“Á–·u¥øZÓoÙì2¡»… <¡Aýä™Á’M‚5r•óø¬lë»tì~»‘pÎ,Š’W›ZÉþ—§•îx\p` +Îs>Ê–Û!éY¹´èض±{VnGTi,5.FѤXX@íI³ULCíJåªd‹=©\µæéúQqò äQpäÈö¢âä#0ûQr\Ú/j«é´^Ôîg*d µRf2¦Wh½*”Œ%H®ñÕ©Ó¤Ux«E#’tnR’jÒ28jÐ3æ€äVñ™æWæuß>(xçá/‰ô_ø'[¸±Öô‰–k)ÑÎm˜»`9\:¼ŠêÁ‘ÕÙ]\W¯ƒÌªP\’÷¡ÙþÎø‹‚ðy­O­RýÖ!jªE+½,”×ÛŽ‹}l¬šM§ý?þƶ¯‚ÿk Mg$phôHõ¿ âDùTÞY’I’Ù€ ’ñ3|†ŠI}U…]`|~+/Äà-E¯Ýlþý®µ¶¶Úî×>Ü­@ € ( € ( € ø{öØøÿwðÃÂ6¿üsmñÅq1ŽÿO¹%Ѭ•ÔI1º´£|Q2…Áºº´@K-Â}f§4—º¿âø×ˆVKƒöT¥jµ5x®¯¾»/›NèüðÎŽ¶ÑF@…}­vGóeŒu$ÙìZEP¼s^…8Ÿ!‹­s¼²¶éÅtÆ'‡Z¡ÕÙÛôâ·Š<ªÕ–Þ Z¤yó™³j˜Èæ´Z²nEñÓŠm‘aá}i‘(ZMšÆ$¡j.l¢H“fŠ¡*nmd)\ÑSgµ+”©Ž íJå*a³ÚÅÈ0¥%ÀiJw!ÀŒ­;™Êej“2”HÊÕ^æn$DzU&dÐÂ3LÍ¡(!¡Œ Š­ÄPš>¼T³H³*húÖm0‘q^*:©Èøâ³hî§# æ> dÑÛNG5v˜Íc#Ò¤Îfõ85ŒJ‹9ÑÁ>•„Z‰ÆßÉ‚y®y3Ø¡œN¥0!¹®i³ÙÃÃSìoø&ìÛÿh_§øCîÏþNØÿx9³ýÚõýúLJж2£þãÿÒ¢~àW‚~¶P@P@P@P@P@P@P@PÂ_´_ü;ö|ýŸŽ« ¦·ÿ ŸÄ‹_6øEü1"Mö[…ó“eí×1[mš.DËÜG½[ÉaXTÄB–ïSÔÁeœsN1´{¿Ó¿åæ~(|gÿ‚”~Ô?/5{MÅ_ð¯üuˆáÑü%û›˜ãY̱³ê$}§ÎÛ壴/ n©þ©C¸o:®6rÒ:i€áŒ5$UÌüöû¶ûïê| ¢( ¸%Q³êèàã ‘y •“™ß :ìZX@¬ÜޏPHbö¨r:#H”ERäm$¢/jNFÊ‘ Ч˜ÑRåûRæ)RåûQr•1|¿j\ÃöBy^Ôs¤Wµ>b}õ>b#µR‘“ ˆÜÕJg=L2gº|ý¥~6~κš]ü1ñÕ¦Žó‰îü9{þ“¦_’Ñó-›åWu‚8ÌÑì˜ *².k®Ž.¥î³ÀÌøw ™FÕá¯F´k~¿=Õú´³¿üGáßÄ=Nß¿tK_‡ú»Ákú]És¦êŒÂ9C/u’neu2¼‘ªó&]€ÉëÐÌ¡SJš?ÃþùÞkÁx¬u0¯ÚG]-i%÷ûß+6ö]¿Tt½SMÖôÝ;ZÑukýþî­/¬¦Y¡º…Ô2IŠJº2Á ‚¯E4ÕÑñ“„©ÉÂjÍhÓÝ2õ2B€ ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( ÆßÚËÀZ—ÂO‹—~*´°¹ñ”æö CÐÛêR{›W‘¤vÞ̯p¹©YY#R lx§‰¾>è? |.ÚάÆëP”°Òáp²^Ê@yÚƒ ³B‚8,U[ õã‡4S)ÊkæõÕ:%»è—ùö]}.×åÏŽüw⟉þ(½ñwŒ/ÍΩq„Ž4b´„VP“¶5ÉÀÉ$’ÌY™˜üÎ#*Òr“?qÊrzmÑ£ÞßwÝÿÃ-,Žv(±Ž+ŽR>Ž•R?jɳº4ËqÅÓŽj:aL²±Ô¶n¢YHIíJ檥ƒŽ•74P,-·µ+—ÈX[qéJå(Žû8=¨¸ù@Ûcµ(ÓÇJ.¤ o׊w%ĪÐãµ;âWx±Nä8•Ú?j¤Ì¥³ÇT™Œ UtªLç” Î•¢g,àUxêÓ9gNåbÍk¨ÜΖs‘[ÆG—V‚{’hZÿ‰ü¯Xx«Á~"ÔôØ6º¶u%¥Í¾ädm’ÆCÈî¤ʱ‚EvQ®àÓGÍæy]4üQñGÄkß´%•ìÞN•gs¸+þX#Ød#ýäa–IXcu}¶]…XzJ=zúŸËÜežË8ÇT­wh®Ñ[uvîí¥Û54K0ü¼×µN'æ8Ú×g§iÖÁUxæ»`›ÄT»:û+sǼQäV¨uvƒŠÞ(òêÎæüQÅhŽ9;—ã_QL͢ʮ>´rPµ-šÆ$ʵ-›Æ,,u›‘Õ D˵K‘´i¬YíRätB‰7“íQÌoì}¨æ¢8CK˜µ@F‡©©*6#1{Sæ3tHÚ*jFr¤Bcöªæ0tÈZ:´ÌeL–©3žP"eªLÆQ!aV™Œ¢0ŒÓ3he4Èh‚TÈ¡‚v3&¨©hÞ21®#Æk6ލ3æ1‚k6Žºr9û¤ëÅe#ФÎjò>¤ ÆHôiHåïƒXÈô賋¿xW †ÕT+Ï•FÏ®¡„QZ#B8}«#Ó§@¸‘JÉÈí…"ÂÅPätÆ‘:ÇíRätF‘2ÇíPäodÂ?jžceLxŽ•Í2A'#EL–)sìÅòý©\~Ìw–}(¹J˜ygÒ‹‡³+Ú‹‹Ù¡¦/j.Ã>c7HŒÅíT¤fè´>ÕJF W{p{U©Øæž>‡¸üý¤þ6~ÎÚš]ü0ñ¥Õ¦ó‰îü9{þ“¦_’Ñó-˜íWu‚8ÌÑì˜ *².k²†2¥î½;;›pÞ4ïáïtkF·ëó½Õú¼_¿à¦?þ-4ܶñƒîÿGñÒ>›6<æýÞ£µqHOž°eåTÌ<×¹C0¥[I{¯ÏüÏÊó^Ì2ëÊšö°ï¯Mã«Ýô¾ŠîÇè½wŸ&P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@<~Õ^>ø[ðëàGõß‹¶zv¥áylžÚ P¡:åéV{{H]&i# ²¢–‡a›å\ëU9ÈíËð5sDpô–û¾Ë«~ŸŽÛ³ù"Ôõ_Ä—çTÖïæì Kž"AÑv$ýI'$’~_ˆ•i9IŸºäÙMºŒiQ—âßwæÿà+%a"⸤Ϧ¥L¾‰ùÖMž…8X¶‘ûT6tÆÈã¨lèŒK±ÃíRÙ²‰~;|ö¥sEJ+<‘SsEòXgøi\¥B3¾Ú Q&þÌö¤¨_ìÏöhQ’é/Ý 9Lé4æùiÜ—‹ÙuâÉp3fµÚOÓ3p3Þj¤Ì¥œ‘cµUÌœ oRfQãÅZg<àTtÆjÓ9'¬‹Z&qÔŸ,}kh³Î«LΖ<æ¶Œ2µ+™¡î,®a½²™¡»…·$‹ØûŽ„Á‚ »°ø‰Ñšœš>_8ÊpùžxlL¡%fŸõtÖé­SÕj~ÙÿÁ4ÿm¿øKm>|Jñ ôö:ÿ“iáãªj(Ðè×QBʶЙŽÿ"tŽ8ã‰\ˆåDEŒùÌõôX¥Œ‡´”ú®þkúÓ¯ŸãÙ8îÅ<%w*˜wðMýžœ³ìöKe-9UÛQý謎ð € ( € (àÛçãü"žÓþhwþ_‰<`K_}ž]²[iq°ß’+§Ÿ X†åd’5¹SȯW*Ã{Z¾ÒKHþð?Èø.>ο³ðU¤ýú»ùG¯[ë¶Í5ÌËÿØáckìéDþhÇ×Õž»¤Ûl 1ÍwSGÉbêÞç éðp2+®ð1¾Ö.€ Þ(òjÈê-!àqÅmyÕfm¢:V›×¹(êKŠ&U©lÚ1'T¨lèŒ QÇY¹”é—=«6ÎÈS'XóPät‘i#ö¨r:¡H›Êö¨æ:=áµÅ*#„T¹‹T†´^Ô)*$M;U)Ê‘GíT™Œ©•Ú.ø›âýÇÞ>×®µ¿ëWæûR¼ ¼Ï€¨Š¡Q@DEUPª &¥W'v~…‚ÀB„ ¬‘•8è+–R=ÊT,^Ž/jÅÈôiÒ-,u›g\)–V?APÙÕ e…J†ÎˆÀ”%Kfñ2¥KfÑ Z›š¨¬f•Í DcÒ•ËP$ íJå¨òè¹J„t®>A|£éEÇÈ'–h¸r”È¢äò 1ŸJw‹ÚÈp"h©¦C¦@Ñ{U)J‘ÅíT¤a:EY!ÏjÒ28êйöìÝûr|lýšmì<5£Ý[x‹á„3´¯á=i~H’£Ìm.÷–îÁdÀùá 4’]˜“éa±õ({»®ÇÆg|%„ÌÛ«nZŸÌ¿ ­Ÿàì’ºGôðWã×ÂïÚÂvž,øiâ{køÚ¦½Ò^T[ýܸ^[†-îŠP ʾÂѳ¦ý *Яh3ñÜÃ-Äå•],L-Ùô~iõÝy®¶g±V§P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@PòÕûsþÖúŸí1ñ&ëHð¶¹tß|=8 ·kA0l—ÓÆÌYݘÊ".¤$.7y·|ö;í¥Ëî£ö.ÈV_EU«ÞË~¶]—ëÝõi#â¸cÆ+É“?B£NÆ‚(¬[=q±v4üë6θDº‰Ú¡³¦14!‹=ª[7ŒM8 Î&ª&ݵ¦qÇ>µ75Q6á´éÅ"Ò5íôòpH¥r’7-ôß”´®U‹LÏðÑqØ•t¿ö(Q²éc­ hÀ§rlaÍa‚r´Éq0®lŽNŠd4a\Z²gŽ)¦dâeË^*“3q3¤Õ&a(”¤J´Ì'“§Z´ÎYĦëZ&qÔMÒµLá©>Të[Ežmjf\Ñç5¼Yä×§sQ$2Çqı°e8Îäpk¶G )-ÑóYž šS¥Q^2M5Ý5g¶§õAÿÿý²åý©<©hÞ2··´ø©á„E¾x¤Y€’¢ê8†Òv&žR´Ñ+戣÷“U ªÁhÿÚçäíTÂbg€ÄJõ “¾‹š/í(ÝÛTÓ_=š?BjMB€ ( € (ùòý¡~%Oñ‹ã¿Œ¼D—óhdí¡èÏi4w=•³º¬©**‰iYÁ;°& •T××e˜eI.¯V:ñÖnó ¤“¼aîÆÖjÊúÝowwóµÊú°DN;WÐRÈqµ.ÙéÚT×lóX©åŒ_wŠéŠ<*ò:«HÀÁ5¼QæU•Ί߰­Å4iœU3$®L£5,Ú(°‹Y¶tÂ%¤CPÙ× l¹ɳº2ôp“YJV= t[-¤³s;!‡e¸íÏ¥fævSòж5Ÿ9Ö°¬p·ö¥ÎZÃû7µãú±@GjjfrôBÐÕ)ÊYá#8¢‘Ë:6*´u¢gé•>µ¢gJeG^µ¢gàUu«LåœJÌ+DÎIÄ…Y„‘EQŒ‘4fÈ¥\ŠlKsá:Ölé¦Ì9׬Ù×a^(眎êLå®—ïV=:Lå/Ó½+ ¥pújæ™îa™æÚÏÝ&¹*EƒÜð?Oä£îè+Ë®ì}ÞSO«Ówìñðüü.øð·À³iÙzž›£[JÇíhòµ Wλýææ72L~V(3…€+äëOÚT”è» õL%*6³I_×wøÜöZÌí ( € ( € ( € ( € ( € ( € (ðƒöïÿ‚–ø§HñW¾~ϯý˜šgÚtOxÚXåŠö+ä$Ð鼯“åì–&¸effv0ù~\sÉÇ_ÉîÄú,§(X‹V­·EßÔü<·€0+ÉœÏÐpØk%dkE+žR=š4l_HÇV.G£N™iR³lë„ • PaW ‰2­Kfñ:¥Kfñ*ÇëSsU§µKf±‰0Ž•ÍID~Ô®Z‰2ÃíùÒ¹¢(ƒÚ•Êä$Ú‹”[gµ+”Cl{ .‚}˜úQqr!míNâp kséùS¹.-)܇»CŽÔÓ3•2‹ÚªæR¦Vx}ª”ŽyR*Ih¤rT zÁÿ‹¾>ø ãý'âGÃ[ìZí–c– {mFÙˆ2[\Æó!}«‘AUtdtG^¼>&t$¥|öo’ÐÌèJ…xèþôû¯?øg£hþ“cÛŸµ'…Òí-´o‹º4 Ú߇ÈIS!~Ùg¸–{fb ©%¡f䆎I~— ‹Ž&?ÞêÄøƒ‡ëduµÖ”¾~ÏóZ®©}£]gÏP@P@P@P@P@P@P@P@P@P@P@P@P@P@P@Pç‡üÓã]ÇÂÙ»SðÞ‹yk‰þ!\ÇÜD&ŽÁãv½™ tc*y@[±|³xŒX nÀ,n>.K݇½óé¯MuóµæfÝ0Å|ÄÙû–’F¬KŒW<™ìR‹Ñ®O5›gu8—£ZÍqF„Qô¨:"h#èZ“x£jÚÇ-ÜÑ#¥³¶'i¤u6šnpH©¹i%®˜¼dP]ŽžÓG™Úh*Æ’hƒþyÐ&Ò, '1ùPO2#ŸA<Ÿ¥:fÖ„Fp´X9“9»½®~N~”“9KÍ5—8îK‰Ë]ذÏËLÍÄæ®mJ’qÅRfR‰4^ÕI˜Ê&d±õô«LÂq(ÈjÓ9¥‹­Zg%H”äZÕ3†¤J2/zÖ,à«:Të[Åž]hWŽx®ˆHññ4‘×ü)øâ/„~?Ñë¯,ŽŒ¬­’)V AörìLiO–¯Á-èÿ®—?6ã<’¾? «àÞ)>hl¯üÑ»[5Òé9(ÝØþ²?dïÚBÏöøw6¹wam¥øçDœXkºE¼êè“l —¦ã"ÛÊ7ló9 ¨O/ÌoOAП/Cár|Ò¶VŽ’[¯×Ñôù­msê*Àõ‚€ ( €>]ý±¾)Ý|'ø â½WHÔþÃâe£Ðô™”Lg¸'Ìh䈃±Û%̨å€õ8VêÁÒöÕ”^Û³ÂâLÁå¹mJ°v›÷c¾ïµ¶i]§Ý†~² 9\`tÅ}µè/fÕ¯&{ž‘ ÅzTÑñ8¹êz6;p+®ùÜDŽêÂ>uE%yM¬Ål‘çTèb3Þ´µŽ9K™–ÇJEE"Ô6tAcJÎLí¥ôiX¶zà_Š>•”¤z4i‘EÀâ¹å#Ö¥GBêEíY9ôè—c‡Ú³”ŽêT bjËœìT}©s”¨ äÑÎW°"x}ª”Œ§@®ðãµZ‘Ë:6*I+E#Ž¥"„‘rke#ΫH£"u­S8*Ó(È•ªgŸV7ZÕ3Šq*H+DÎ*‘+0«Lå’!nµhÂHˆõ¦dÆ0⨆fܯ¡›A˜W 0k6vA˜KÁ¬ÙÝIœ½ÚòÕ„N“9M@|¬+ž¦êpZÈa\³=Ü9æÚÈýÛûWCèð{£®ý”~\üJý§>Ûˆ®N‘ợâkùífŠ&-6¼‡Îäk³k*‚Ûdb6àºøNJoÏCõÎÂýkí{îÛñ±ý×Í·P@P@P@P@P@P@øóÿ-ýº5ß„ ÿ³ïÁëÿ±üAÕ,ã\ñMÊ´iw¶·Å⼑s#h¢’7/*I6"¿³\«sÛÊ2Ï­ËÚTøWãÿþwí­À ÇäNgè˜\2VV6bŒ `W,™îR¦‘~4ÅdÙèÓmÚ²lì„K*µ PaV¡³¦1'U©lèŒ Õ{ †ÍãuLKv5Q'T¤Ù´bXXê[5Q,,yíH´‹)µ+š$[HEMËQ, è(+”m¥+”°¶¾Ô\|¢ý”úR¸r6‡ÒÔaµ8éEÔ­%±þí%ĪÖävª¹¥Y ö§r O ;™¸ž?j¤Ì¥¤‘{sT™„àR’,ö­Ž:”n[еÿx?Y³ñ„÷Õɵա8ªLÂHš 6àWT󸉽Œ|-tÅ5iju6 (²<êš³U9¦ebu4™¤Qn5¬Û;iÀ½ô¬dÎúQ4"LÖRg£J”)ÓŠÂLõ¨S5â b¹¥#Ù£KCB(zqXÊG¥J‰¡=8¬e#Ñ¥@¸ ö¬ùŽÕ@_#Ú—9j€ï#Ž”¹‡õr‡Ú­HÂt h¤qÔ Q–,gŠÖ28*Ò±Ÿ,]x­£#Í«HΚëú·xr¿Új?î?ý)·Uà®…P@P@P@P@P@P@|7ÿý¨nf—Z·…uX~*øšài^Žxá¸0?Þ¸¼0;‚É YÃm‘im„ˆÈäêÏ’7;08o­UQ{u?”+«ýS\Ôµ o[Ônµ kP¸’îóP¾™§žîy¼’Ë#Îìij3I$“šñêNîçèø,:„TRл xŠä”¡¡NÈÑ+ 3Ò¥ê-dÙß–‘j:áÊ®+6ΨÄV¥³¢1'U¨lÞ(²«RÙ´bXU©7ŒK Kw5H´‘“Ú‘¢‰~83ÔR¹¢‰z;j›š(—ⵎ)\¥M,¸R/”´–9í@ìhC¦–þ‘léD +ŽÃN–»NáaŸÙ9ä¢âå(Ë¥ã9^h‰Ÿ.›ŽÔâeM§•=)Ü—6[23•¦™d¶Ýxª¹” gÉ ªîc(¤‹­Rg< Q’/QZ)Xä©JäVwš–¨éúƨ\ØkÇuie+C5¬Ñ°d’9†GVƒ [Ó¨âÓG‘‹ÂB¼%N¢ºz4Ïé÷ö&ý®ü9ûJx ÇFÕu#ã7‡lbMMº1¤šŽÐ±FÜ"¢´29Õy.áÚby>¯‹Ž&Þ[ÿ™øpý\“Ú_º“|¯·÷_šüV½Òûz»› ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € þ7þ=|TŸãwÆÏ‰åšêK_jÓM`/`Š ¡°LEi‰P²‰~:ÊG¡L¿AY³¶™z:†tÄÖ·Z†tEö«µ Þ'a§Å’´™ª;­:JñRjBÓtã)^8 ½·=;FÒãM„®i¥s9ÔHô‹+*¸JÒ18ªÖGCœ8ù?JÕ@ហׇN'/éV rÏafÒ‹g)C€¡Š·Sœ¾ÒÏËYJ™èÑŦrÚY¾JÂQ±éÓ®¤yæ­¤pÄ-FÆû£Ë5,‚ÇmQ ó]FÏc6E4ÌÚ8Ûè:€1Tc$r7P•$â©3#UëVŽy#>Eê*ÑË4gÈ+X³Ž¢)H+X³Ï«>UëZÅžuX™’­tEžUh™S¯Zèƒ<|DL¯>âÊâ;»IZ+˜Žäuê?ÄGB85ÛB¬©IN.Í/›`hã¨N…xóAî¿­»¦µOU©ýmÁ>¾4ê¿f ëÞ"Õ5 OÅ:-Ôú.¥©j%îdM³DDŠs)[{‹xÚGÚHä-¸üííT³jqÙ«ÿ_3ó,´„%B³ntäâÛVnÛ;yŧçÝîþÙ¬ÎР€ (ùýý®üh¾=ý¦|{4¯Ûô˜t?Üy?fêÄ<ª³m¼{Ï™³œü¤¦ÚúŒ®—%í«×ü¿ð~=Ç}g1©ïZ+åºÿÀ¯ÿ cŽðô8HÉžkèi#ñÜÂz³×4¨ÇË]ðGÉâ¤zœ™Ûšë‚< DŽÎÍz`fº"xõY½¹Çjç,š5bR&¨ÎéìZAS#X"ìb²gu4hB™Åc&ztas^úW4™ìP¦jÃãŠç”b…$mAÀâ¹§#ÝÃÑV4£‹§„¤z´©1EœqXJG¥FËÂjËœô[ŸJ\æ‹ ;QÎb´ûU©µ(䇫U#†¥6hÇÓªë7‘YÛ[ïu7Ë!U]Îè£'–`$RmE]•J¤”`®ßE©ùñçþ ãàýÏ¡~Î^>*ÔÆßøª|K özj©ÝZå.gÊ´ñ¶óo±ÑY|Õ<ðWÌ!OHjÏ®ÊøCŒjX‡ËËò_Èü1ø½ñÏâßÇ߯ˆ>+xûTñ-ͦVÒ;§Xím2‘£›{hÂÃñ e¼¤]å6[&±•I¸'7«=*X<=‡[M¿)ó‰ÛìÒ2ÈоæÜ ©>bH‰õ˜lDq0R[õ?Ÿ3¼ž¶MŠ•‹Ýwå}×®š®¾~MMWAã…P@P@P@P@P@P@P@P@P@P@P@P@P@P@P”|yñ.·à¿¿ücá«ß±øB𞯩é÷~ZKö{˜,å’'Øà«mtS†`‚8¨¨Üa&»8*q«‰¥NjéÉ'èÚ?+Oºµòµ7?}Áì¸k’G½D¿e#Ц_ŒVlì~.µ ê±nEC:"oY·Ìµ Þ'q§0Êô¤Í‘ßi„µ&¨ôýò´ž‡®h¨$Ú6æ´G%Fz^•i»nGZÞ<ŒU[Ŧ”$Û]1…Ï®+”èí4\q[F™çUÆØž}ÂStÌáó9ëÝß'éYJ™èÑÆyœv£¢|òW<éž¾ªÔó-_I 8ÛÒ¹\,Ïv…(ÜòmoJ#w-XÒçvG‘k:qBß-I»Gœj„ªLÊH⯠*NE4ÌdŽfá0IíZ#žhÊ•zÕ£–hÏ‘zÖˆãš(È:֨ਊŠÚ,óª£2QÖ·‰åVFdËÖ·‹<šñ1î"º`Ï Ÿ¯ÿðG‹vÞø­ã?„z•Í´IâÝ8Mdi¦º³2L‘FÊvªy3_ÈæEÆR0½¼=OiC—¬_àÿàþgåù¾à³WU/r´Vº¿~‚¼6ïÊþÑ…QP@SÔu?HÓïµmZúÞËJ²…î.onåX¢·‰³É#±UTXši6쉜ã¹IÙ-[góÞ!Ô´ÿ„Ÿãd–{}*<5Ž#ìò[R:ºîG2¬æGT]Æ–9O=|Lh-w=œ«%¯™É8é¯üçÇãwÇ¿‹¿´¿‰í|Oñ_Äok94Í*Ö·²Òb–C#GKÿS#—•Ö(ûì\x8Œlª=Yú¾MÃTp‘µ(ê÷owý}ÇŒêâ-'L•™ÂÜL¦8T6Ö$ðHÇ 9ü‡q\Ø{â*«-¯úó=œåÓÊ02rvœÓŒUìîôm[ùo{é­•Óhâ­#U zu%sâ0TÔRHÞ„p+’lú*ÐÐŒt¬$zTÑyfÎø"Ò•›:é¢ÒŠÍpE… éŠ'QÈ,Þ(´¢¡›ÅQj[7H¶‹“HÕ#F‰ç,Ñ#NqRÙªFͼ;ˆÈâ¤Ñ#~ÖØ(4Hèím:`T–‘ÑZXÀÅ$t6úAã"ØÜ·Ò À AV7âÐY¦€±8Ð÷ !Ø?á,q²‹ŠÅ;¯²gä8¢ác çAÈ?'4\V9˽Àb«L–ŽRëJ# ¯4 £—¼ÒˆÎªæm½Õ“) Š åŸ¹´+œŠ´Ì¥hqž*“9å2XºñV™ÍRl±õ­c#†­$ÏGø!ñ‹Å¿³ÿÅ/ |Nð…ÝÒͧ΋¨iÖóˆSX°.¦{9IW]’*à1FØÁ$Q½Žü.%К’>K>É©æ˜iШµ{>Ï£[më®Û3úôðlj4_xkÃÞ/ðÝïÛ<;®XÁ©X]ùoŸm4k$O±ÀeÜŒ§ Áñ_])¥%³?žkR ’¥QZQm5æ´få30 € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( €9?ø;Lø‰àoü?Ö§ºƒFñ6“w£ÝÍbÊ“G Ì/ ´lÊÊ+’ VÆAéS(©'ÔÒYP©±Þ-?»Sø§µ8U¯”©¹ýƒ~ê6c=+–G»I—ã5“= l½¬ÙÙ^ˆô¬ÙÕjÛ·J†tśֆ,Þ'm¦¶JóRÍ‘èºWU©5G§è™v\w¦‰¨ì{‡‡ W=Mkyõ§cÖ´¨”⺠6îzN— ¿-vA;‰›;«+@@!k¦1QÖµ‰çUFt·‰æVF\íoȬŒ¹‡º"Ï&ºÐô_¿µïÙÿã>/xv´^øzðM5ŽõŒ_Ú²˜î-˲8O6’=û¡`ÀnQ]´*8=˜Í°ÅSå–ëT쮚í~êéõ³i4h~ñ>‡ã øoÆž¾ûo†µû }SN¼òž/´[OËìp®»‘Ôí`gÅzißSâeâ÷Fý (æ_Û'Äú‡„fO‹Ú¦› ¼·:riN—JÌ¢Ùâ³”€¬áÕ9À`¤‚2N*uâŸõmOˆkË•לwµ¿ð&¢ÿ~øV©îkì¨#ù§4Û=ãA1^$|6:[ž¯¥.®è-Šg}§'C]P<C;+5ÆÚÞ'“TߌŒZ_C–Å…íIšEVl릋ðuŒB†æ¼8⹤Ïo›–ÉÒ¹fÏ OczÙ:f¸æÏ¢ÃS7­ã 䜡ÃRº6`ˆqÅsNG·BŠ5¡‹§Ï)Õ %ñ+cÐT´ÅíG0{¦,Sæ!Ò±VT­"Î:ÔÌÉ£ë[ÅžUzf=Âu®˜3ÄÄÂÆ,ê+ª ðñ1î`×Lâb"µ1&kª'ƒY²Žµ´O.²3e­âyU‘IëTp̬բ9$W= YÏ"&èi‘Ô£)ùM"⌓Á¬ÙÙLçnÛ­bÎúH寛­c#Ô¢ŽFùø5„VŠ8 Qùl×,Ï{ 1×a늩ô¸%±÷¿ü÷jÇ¢èÏQ¯•ÍÝåŸè~ýáÔmB»ÿþÜ~´×Ž~ŽP@P@P@P@P@øëûyÿÁF/>j×_?g]bÕþ"XÜ×üX †òѲÖP$ŠÑËrHÛ+2²D7F˜±·áÅbÕ/v;ŸQ‘ðü³ªÖ^çEßþçùþyz¦½©ßë:ÍõÖ¡¬êÉuw}3O=ÔÒ1y%’F%Ù˜³3I$“šùêø‡&ÝÏØò¬ža¨Ù#¼Ò<:[id¯:¥KŸg„Â(ì7ø«–šÖ¦ÕbK_´’]Êœû~ìcêkØÊRö3©Õ»}ßðçç Õ›Ì0ø[.XÛÏÞ“Oåî+z¿—j½+ª£<$nnD:W$™ïÑFŒB±‘éÒEÄ“;`‹H*×M–³gdaGJƒ¢(ž1ÍI¼QmAÑÒ*Y¬K±/JLÖ(Õ…zT›$kÁH&‰¬=)$tvcT¶ZG[§Ù—#Š Hî4ý<8æ‘Im‚œqJåEžšœ”Ò"SQ:‹}=vc`üª¹L]kF›è£ò§ÈOÖ —LݧÈKÄ‘\éY_»Ú‡Ãs¸ÑÝò~•67K˜Z8Ã|Ÿ˜¥bœ¬pºžŠ2ÄGϵ1s&p÷ÚVÒÀ­ÑÅê:_$…æšd8œ}õˆ¸¦e(œÍ® ㊴Ìex6犤ÎyDÉš>µ¢g%HsÅkhÈó«Òº?b?à•Ÿ´­Þ®\~Ì~'“ÌÒµ/µê¾»–Yäx.U—J˜dHZ4žåOîºÍí:íú «¯°—Ëü¿_øsñî=ÈÒ_Út–ªÊKM¶Rï{Ú=t¶Éº•î—P@P@P@P@P@P@P@P@P@P@P@P@P@P@PðëjùU¯”¨µ?~ÂNéPµrÉõµc$z4™v3Ò³gtz3Y³ª ÔºT3ª,Ûµy¨fñgq¦ºü¼Ô›Åž¦LÞjM¢zׇäQ2¨¤ö=·Aü™5´Z<Ú´æÏ`ÑdWÚ3ÍtÓg‰‹‹‰ê:X^+¶ÌâEÒ×;Ak®Ïb™Ò­¢‘¢¶å<çU¢íšìå{TÊ&Ôk;œ6¥§åìâ¹§ÛÃ×Õjy®­b0ÿ-qÔ‰ôXZïCƼAb¿?Ë\5"}N»Ðñ-zËò¼W#ÑŸC sFçŒk¶c/L™#ÉõKr ŒU##ˆºLHçš9û„æ´Læš2&^¸­ÇQÒŠÒ' TP”u­¢Ï:ª3e¼O.²3&kxžUdeÊ:Šè‹<ŠÈǸ\ƒ]g‹‰…Ó?¤ïø%Wíeÿ cáÊüñîÿˆ~°Q¥´V>Tw~„A[¤C°ÍºDÙT-Bß½q3NNouŸ˜a=‹ö±Ù»?_ø+Sõ¶¶<À €?9à§)¿à_ǧŒíþHßס–«Öù‘ñüo.\µ~R?&<4¸X}…}m=f.íží ¨Øë^#áñÏVzž”¼-vÀùŒS;ÛÀ®¨ž vvkkxž]Wcm(µmXçæ¹ejY¤ ‘Ž•”ŽêHЉyŒ™èщ³nEsMžæ&õ²ô®IŸG†Fý²çÇQŸC……ΊÝ8Å6}6'Jæ“=º6`޹§#ÜÃÒ/ˆëžŒi c¢àéºqT™Œá¡FU­bÎ Ð2æfº yÕŒ;žõ×LùüWSzêàâ Iû×T bOÞº¢x5Ù—)ë[Äòk3:S[Äòë2“šÕef5hæ™t«9Ù}ÓO¡™›1À¤Íb`Ý0¬™ÙMåáëYHô(œó}êÂG«E}óýêç‘ëÐGŸjó75Ë3ßÂÇCÌ5É0$ç±®*¬ú\ v?N?à™>Ó­¼ñSÆñOpÚ®«¯E¤Ï2˜R+Kd–6Q·!Ë_Ì– …L‚[äóY^ªdBð  ¾uzÊVû’·æÏÓJòϺ ( € ( € ( € ( € ( €?ÿà ÿðP–ðlšçìÿð]ÿŠä³ñ/Œl$ÿ𽜃þ_:¬’ø÷åTùù6üX¬R¤¹c¹ô¹G,¢©U{‹ñÿùŸ„šN•¸¢ªàWÎW¬Û?iËrèÓŠ²=wBÑì ¢¼ú“>¿ †zh{O‡ü2²ì8ù­rJW=ú4TV§Å®–ûâ7Œ%K!`¼k=›·gÈÙÀûÞ^ìvÎ2qšúÌ$=žœo}/÷ê?q#ë™æ.¯-­.]ïð% ôß–þW¶»˜V R¨k„I1v®YÝ"üf±‘éS-¥fÎÈ“½fÎÊe¥ëPΨ–¡1,F:T3x–TEØÇJ“h—âÔ³Tk[®H©f¨ßµ¥IªGGiH4™hê¬bRÃ4‹Gu¦Â8â‚ÎæÂÜ6ÜT²ÎÆÊÌñÅ4Œç4޾ÊÈü¿-kqÔ¨™ÕZØQ…æµQ¹çÔ¯ÊÍ8ô¶=V­@ÂX¤^M ŸàªTÌ%‹ ´v*>J0†-_s}¯ÉYºgd1žf æŒpHJÍÂÇe-k¾0x⿇¡3ê^¾[¶³4ûm³)Šæß{£„ó ’H·ìb›÷/Ì­¹Ý7žrÂÇN®îÕו¿¥§‘ýŒüø³áŽ <%ñ_Às]Iá@Ó[­ô át‘â–)9c’2T²„£:•céÆJJèøjÔeB£§=ÑéuFA@”¿ðTMwV‡Kø'áhnöèW÷š–¡qmå¡ó.-ÒÞ8_v7 ©wp0 •\z¹TSœ¥×Cà8ú´ã‡£I?u¹7ê­oÍŸœ>C² :ñ_SHü0z³Ü´%Â"úW§HøŒs»gªéc µÛåñOS»° éâW; !Ò·‰åU6‡j¶s¢eëRΈ"íYHí¤iEÚ°‘êQF͸Î+šg¹†[ ²çWÙô¸XÜè­W¥qTgÓa!±ÑÛ'¸¦Ï¦ÂÃDm[ÇÒ¹g#ÞÃÓ6àAŠä›=ì=4_1Y6z ÃE4È”Q¨ Õ&a8«ó Vñg›]XŸ8ÍtÀðq,¹ï]”ÏžÅu0î¥u@ð1,ø=q]p<K0æ<šêŠ>~»ÔÌ”æº"y5™›)ë[Dó*²“µ¢8fÊîzÖˆæ“!j£žDNp*ºdÜ?Z†os—Rrk&ÎúhçnäëXÉž…(œô¼žk 3Õ¡Ž¿`Ög¯B'žê’ Í\“g¿…އ•x‚l$Ç=pÕgÔ`!vÚø'¯†týökÑ5«)îçÄú¶£ª]¬ì¥c™'6AcA åÙDpKÌç8!GÇær¯+ô?¤xCM6¾ÕÛûíù$}½\GÓP@P@P@P@PÃß·çí=uû2|¹Õ<)¨ZÃñWÄ×JðâO7ݾõÅáÜHbÎlˆ³Kl$FG åZ§²…ÏC-ÁZÕDá•Rü6;ˆùxªQ9çZŹ4Ü â©ÀÊ8L‹7¯ËY¸tñ&%Æ™~ZÍÀí§‰ó8ÝGJ›ä®yÀõðø­78KI`V¹å ÅêG˜ëz*Äk7¡Öš’Ðò­SM+¼¦&5Õ¬0XM3&Žö×ïqTc$r·pãÓ>جõ˜Ôù[wʨŸht'j4’J–ˆ0{¹V#–^Ê[?Ïþù”ñþMíè,u%ïSßÎ?uôzïd¹™ý×П…P@P@P@P@P@P@P@P@P@P@P@P@P@P@üîÿÁ_þ`|jøqñ*Ö×K·°ñn„ö3}•6\ÜÞØËûÉ®0€6`»³³6Ø6ª‰Ÿ'1‡¼¥Üýƒ±W£:-¿ußÊÏ·Í7ó?(­äàW4~•‡©¡¥ò+ #Ô¥2ú5dÑèS‘n6äVm‘~6¬Ú:á#B9Z†tEœÌ¤ñPÑÑuÙÊŒóRozfƒ}†^jv5µÏoÐ5„ù©$­cÙôà6’ÜVÔäy¸Ê7G±hZ§)óW¡NgÉc°ÛžË¢ß‰|ÜסNGÇã(r¶wV“–ÀÍtÅžXXÞó>AZÜáåÔȾ]ÈØïYÈë ìÏ>Ôí‰ÞH®YÄ÷ðÕ-cÇüAjAryõb}n­ìx¾¹íãçÔGØa'±â~#´ IÇŠ=6xGˆ-ð\âš2g–êíÅZ9äŽRö+õ=GKåV» |Æ+s»°þê‰á×:û>0kxže]Í„9ÇOS¬XZ†t@¹ZÎGmF x¬$zt‘·l:W-CßÂ%¨é\U§Â#¤µŠá¨}FltVý«ŠgÓaM¸â¹fÏ{‘³ Œ\²g¹B(¼§"³g|]Ñâš3в\u9j´‘›;ŒVðG—ˆž†Ãõ®¸#çñ5 +—ë]tÑóØ©˜S¸æºàŸÄÔ0îs]pG‰š0ænMuEi]™Ò°­¢.¬ŒÙXs[ÅefScZ#Šl®Õ¢9¤ÈZ¤`È%<lKs åøjÊG]4s—/Ö²“;é#𼓭c&zTbq÷òòÕ„™ëP‰ÇjðÜ×<™ìP‰çš¤Ü·5É6}“xŽà¦æ¸j½ªËéûÈþ†ÿeÍ Gð÷ìéðVËB³û5χ,µ'Ìy7\]Ä.§|±'æšy[ì(>/'*²o»?¦²j1¡—ЄU½Øýí]þ,÷šÄô‚€ ( € ( € ( € ( € (ùEý¾ÿhCûFþÑZìš©ö¯†¾ / èDþe½ÖÆÿI½M’ÉùóÛ4{|Ëx­· ­xØú÷v]ÒxS+q¦ªIk-Ëúî|ǤX Û_?VMŸ¯åô£’=cúfé”mëŠàœ«ÃS²¹îö³é>Ò_YÕäÙn˜T@2O!舽Øàû $H׃­¬¨ÑWoîK»òÿ†Üãâ.#˸O.©™æu9iÇeö¥.‘ŠÒòvÑl•Ûj)µÊ[&¥ã]R=gYbL­­ŠcµCŽ« ÌFI€U°d™%¶Š„5“Ýõoü».ž·oüáñGÄüÇó b1–”n©ÓNñ„_Ýy;')Zòih¢£þtÚt¯¨H`ö:+nÕÅ3é°¦¼UÍ#Ú¢hÆzV,ôé²ÒÉe¸ÍC;)²ÒšÍpe…¨gLK1ž• Þ%´™×å¨p:á‰9-GL±Û\òêáñ'©éÇæùk–p=ì6 ómgNáÆÚç”Of•[£Éµ(çmfÕŽ¸Ï˜òm^Çk:•äP69ÔlÂîÀâšfRG Ö›«?3Õ+CŒ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € (ó«þ wðJçâÏìÕªx—D³µ“Äÿ.ˆÒG·„Í&ž‘ºÞ“»©‰D\°¼Ãdˆ˜¡^\]?iOMÑîpþ7êxĤýÙéóèþý<®ÏæÖ\Íx"~½„­tkÆý sIÕ)š1µ`ÑéÓ™q³hí§"ìoY´uÂEè߆ލÈÙ·¸Æ*Z:## ³œŒ1o¥fѼdwZN P¡ÝRѼYëÚ±‚Ÿ=#d{F…¬‚cRüz°¦”•eе,”;«ª”χÜöMWªüÜסN¡òÌ'3g¦éš¨/Ì3]°©sæñ8WtßÚ"€Õ·1æ}_R6»Êœš\ŪVg5¨È ±+³ÑÃÄò=}‰ß\O«À-ÖWïןPúüØñ¯.wÖ®äx?ˆPüQb/sÉu†aŠ£)uèñVŽyÜàdֈ䨌©GZÕ5 ëZÄóª£6aÖ·‰åÖV3%ï[Äò«“ è‰äÖFdíoʬŒ·v†HæP FÁ€= 5º\ÉÅõ<š“t'±Þ-?¹Üé5kBUøùOzáÃÔÔúœçx¾Çö‰ð#âî‰ñçá€~.x~"ÇÄv q%žéìWHÍ;÷Ž3'•cwVî×LO³:û.Õ¼O.±°;U3“§Z–oì]kôM({V=Z&Õ¿Q\Ó=Ì7C¢¶í\U§Ât:KnÕÃPú|#:bN+ŽgÒáY¹é\³G¿‡fÄ-ÅrÉÝhYVëPÑ×»ÓHÊs)K'µŠ8+TÐÊžN+¢<ŒEM K‰1šë‚< MCêJë¦ÅÔ0®$ë]p‰óøš†-Ãõ®¨#ÂÄLÆ•ù5Óxu§©+ÖñG™Ve &µHóªH¬æ´Hä“ '©«0“ àfƒ=ÙNip§š.Tc©w.泓;iÄæ®eÖ-ž…8œÕ죞k3Ò£Œ¾—–æ¹äÏb„N3R— Ü×<Ùìáã©ç¬øÍqÍŸC…†Ç™ÜézÇŠ5}#ÂþµûWˆ5‹¸¬,m|Äϸ•Äq&÷!Ws²Œ±g’5çbf¡'ÐûL— ,ExR‚»“I|ÙýHiºn£iÖF‘amc¤ØÂ–Ö¶Vq,0ÛBŠ#TU¾1»êÏéxÅA(ÅY"í ( € ( € ( € ( € (óÿþ ;ûIjŸ³ÇÀ9bðͬ~?ñÅÄžÓä:ƒZÝé°<BÙ#"FxG–ŠêÊ#–âbp#|kÔöpº=³ õ¼BƒÙjÿÈþ^ôˆkªð|Íyݶ~ã”áTa¤zn™(yugsî°8k+³Ù¼+&N+’GÐÒVBêZ”¾.Öa‚û ÁŠEðÉ<€fê8^OËÈÆâ+õÉ– Š­U~òzíª_˯Þö×Mláãž+’¡ïàÕ'ÖWï× Cê°ocƼF¿ë8¬=kÜð¯§ß©e#Èu4ùÞ©Èâo—ªÑÏ3›œu­ÉPÉ—­hŽ*ˆÎ—½mΪgK[Dòë+™’Öñ<ªÈ̘u®ˆžMe©™0­âyU‘“8È5ÑÇÄ+¦uиÒ,ÝÛå9õ_”þ¢¼éÞäŸÏSí0íbrº3ŠÓ•/œ}×ø­Úoø#/Å‹˜u¯Œ?/¦º’Ò{x¼[¦DCä[º4v—¬òñ!yšpUù$?!'·„•ãcòî!¡ÉUTù½ÕØ|áü¼|pñ.¹â¿Ú3㮫â+ßµßÃâýWMŽ_)#Ûkgu%¥²adð¦â76̱,I>þW+ÐOÍþlü‹ ©æ•"¿–ï§úšþ˜½} #ñüÁÚç¹h‡åJô©ŸŒÝž¡¥tZìó8­Îîâ×TO¾ç_gü?…o˪lÕLÆ$éÖ¥›À¹c#¾‰¥éXÈôè³fÛµrÌ÷0¯c£µ=+Ž¡ôøFtV§®*‡ÓaÇCnÜ\S>— ͘\ W4‘íШ‘« ‚¹åØ£UË€3YØìö–EY%«Q9*U)I/µŒN µQ•q'ÑžF&¡‡q'Zë„OŸÄÕ0.d®ºq>wTÄú×\àâ*ó¿Zé‚öž[|¯cú/¯™?r ( € ( € ( € ( € ( æïþ ùñZ߯?|ðŸNšÖkO‡úCMxÉÉ<†¡åË$Níò: Xl$SàÍ ,HÚž~6vV>»†0ÎSçîÿ#óWKƒ;F+æëJçí¹m%®zfjASŠóæ­ÃI=›[¿žÏO·Ó-F%ÔwDîT"¡;€èx'¡Á¯w†²øã1N¬ö§góéòV;n®~WãoÖἊ8.•1|ñm¤Ò¦’SJïIKš);?uÊܲåg¤xE"8N÷Jýs OCüîÎñš·sêï é «Û^å gå¹®-¶ÏÌŸÚ·ÀÉà_:ßÙã†;A·QHîÊe,“ÝÑšx§|T+.1÷Gç|Mƒú®:VÚ~òùïø¦ÿ«Øþq³þ ª6ç‡n‹m$½Ë8ZÛ¥NPÚM´ï‰øM£s_-Q¼àämÂÝ+–H÷¨ÈÑŒñXHõ)2âͰe¸Íg#¶“-¡¬ÙÙXCPΘ2ÊECGLq è‹-£sRÍâË‘¿ARj™±lüƒRÍâÍûi0EAªgGm/Nh4Lìté¾íIiž‹¤Ê¿)Í‹SÒ´©ÀÛÍK-+¡¤ÌZÚ óqQ¹è:tŸwšëƒ<DNûL“”çÓx8˜îvÖÏÒºQâÔGSab ­à2¼¬vC˜k¡-"s÷ˆ$¶'¨¤Ñq©b£ÚûTòšª§?©Z}î+Äô0õNR´ûÜW,â{Øj§œk6œ7ÉR'ÐàêžS«Z}î+Šq>›Vç‘ø†Ìÿ-bStx®µi±œLÍ£Ì5xq¸UÉ%Ü{ФsÍåÊòkDrTF4ËÖ¶‹<ú¨ú“öø©­|&ý¨¾\éQyö^*¿‡Âš•¦äO:ÚúhãS½‘Šùs‹yð»Ky;7*»õrêÎhÛ®ŸyùÿeÐÆåµy´pNkÖ)¿-Õוïm꺾¨ü( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( Éïø*ïìì~!|$Óþ7xcKó|eðû?Ú?fƒt·š,Œ<ÝÛ"iìÒ˜ntŽ(žñÎI®L]/i ­Ñô<=˜}SìäýÙ~ðvûç> Aæ¼)ÆÇê¸z×W5"“§5Ï(ž½…øÞ±hôiÔ.Æõ›Gu9–Ñë6ŽÈL½ô¬Ú:¡#BHïPÑÕ ¶— ƒPÑÑU•ã ¼ÔØèŒŽóKÕl¹ ¦zæ…¬8ÙóÓW±ìú¶H@ÏúÕ'c9ÁIXõ-3[À_›õ­áPò18;êw–áù~oÖº£Pðë༎®TJœ·5ºÏ*x^V6[ѵ¾jNCNGQ½S»-XNG­‡¢Ï=Õ$»+–nç¿…#ñ}`z‘<7Ä* aRh$Ôâ%Ü犤g#…Ô#uR9är·Öˆåš2%­QÃQÒ÷­byÕLÙEoˬfKÔÖñ<ªÆd½ë¢'•XÌ–·‰äÖ2çkxMttš †].X™Á1H@^2ªpžêâÅÇ–ª’[¯ëô>£‡ªºÙ|éÊW䓲ìŸâùµ~}µ¿àGÃÛá“]kÙºŠþÑáCýÏûgÚý–™7_Çcó®Ücæ`›ë¿=l|—ᓦ䖫_óüë½SàOäÂÞ&×|g5ÿŒ¼Q}ößë××:ž£yå¤_hºžy%•ö T]Îìv¨ 3€â½¼™óabüßþ”Ï˼J¦©g• ¶Q§ÿ¦ }áÖÇšúJ'♊Ü÷ ü¨+Ó¦|N7vz––F» |Î)jwV'î×TO±×Ù“Æ+xž]]Í„Îêft,-&oäu”ŽÊLÐ‹ï ÆG¥GtlÀqŠæ™îá¬t­Ò¸ê#é0’Øè­[¥qTGÓa$oÀü ãš>‹SCZé\òG³B¡§ }k Fç«JªH˜ÏÇZžCgˆÐ©$õ¤`qÔÄdŸ¯5¬`yõqMÅÇ^k¢¥q÷¹®i³ÛÃS<×X»Æóž+ޤ¤ÁÒØûÏþ ‘à½GPøñ7â„s“¦éi BÕ¼›Ù®&Žy6Ï»á[HwF8ºBJñ¿ç3Z—å‡Ìý£€pN×ö²ŽÛõzùY}çì½xçé@P@P@P@P@ü]|rø¯?ÇoŽÿ~-M5Ô¶¾"ÕæŸO[è!‚x4ôÄVqJ‘eÇk±²P’ÎIcâcfäÙú áãJ1‰“¥”]¹¯ £?VÁÓºZž“¥Nƒn®9Èú<5;ihuýhß‘˜—Â1ÑNé$óÓ8í_ªdwÔpѧ/‰êý_Íí¢Ó{\þñkŒÿÖŒî¾.›ýÌ}Êà‹v _¼Ü§i+Ç›–öHú§Áúz*ξ•öXxÍy¾!¶Û>™ð½QìQ‰ù¾gZ÷>ÿ‚‡hZuž©ð—ÄQÚíÕïío째ÞÇ̆â]¹Ú6µÌÇ wòN>;hÆ2¡U/y©'è¬×æÏé£cˆ«C5ÀÊ_º§*SвÒUã'{]ÝS‚³vVÑ+»þ|Y¿Jüö¢?±0SØÝ‰ºW$‘ô4diDÕ„‘éÒ‘m³hí„‹qµg$vR‘q²hî„‹*j:£"Â†Žˆ2ÜmPΨ²Ú7æ*Y¼Yi¡©5LÖ·|b¡›Å›Vòt©fÉ›öÒð)&uÖBóÍK4Lït›¬mæƒDÏJÒîzsRÑhõ "ô(QžkX8ƒÒ4ËÅ;9®˜3įÏDÒ®Škª ðñ0i…§º1uuAžtÑÜéÅ>\WT™Ù[2ˆÀ=+¡EDîJÆ3Ú™ äM7AJÅ©4bj6ÀƒŠÊhìÃÔ±ÀêV¿{ŠåœO{TófÓå¡ô%hâ¿íÏý¸ÔÓ¼G®øÅñ—†/~Åâ]þßTÓ¯|¤—ì÷0H²Å&Ç µÑNÖN0AV¸Yjš83ꌣ#û`ñÿŒô¿‡ñ·Ä=rÞê}ÂúEæµyŠ+Ï$мα+2©r±¡™Fq’5î7esò¸AÔ’ŠÝè"ß ~]Á}2?ñã^ÎFÏÿJgæÞ*G—ˆñ+ÊŸþšôî‚ĬXö¯¦¤~ŽZ³Ý4CòGžµéR>#»=KIl…®è/ŠG{bFtÄðëu™äVñ<º¨Ü[9‘0ëRÍâ[µg#®“4"8"±‘éQzšÐ7Jçš=œ<ëVé\uô8I›öòcÉ8ŸG†«cj zs\³‰îáêšñLë\Ò‰íQ¬’.,þõ›Û@柎´” ž#B¤“õæ´P8ªb,P’ã¯5´`yõq&EÄýy®ˆ@ñ±8ƒyºó]P‰áb+ËÉ®˜DñqŒ™¥ëÍtF'^©™+ÖñG•Z¡Aß­l‘çNeWjÑ#’r+±ÍZ9¤È‰Í3&Êó>Õ4Þ‚J츛’sY¶uÓu?^k93¶”bòã‚3XIž•g/wsÁ汓=:TÎBþè|ÜÖ‘ëФq7÷ ÍsIžÍ g ©Üá\æ¹fÏw OTyN½z$渪ÈúŒ ´~þ~ß¡øwû6ø´VãUñLGÄ׳ÚÍ,«9» ð¿]mÒ6UwFÄnÉvù<]OiZO¶‡ô`Ö .¥²\ÏçÿÈúâ¹l( € ( € ( € ( € ( €?…M `%x¶~µÃñ²G¥X xÕOÓ0:Xê’wŽÝ• ó$ýÚm$O|ûuü+|£ñ¸ÈBÚ-_¢òóÑ|Ï'Ä>&‡ ðÞ'¤ÕI§N›Oži«©$ì๦¶¿-“M£Ù|£ˆb‰ŠóŠý‡ NÈÿ8s¼_<š¹ôß„lþhÆ+ÙÃÄü×6­£>™ðÅÊ…‡ìQ‰ù¾eZí¤|Çÿð:k´Yiž}ÿ…õTó¯<ýŸe²¹_*O°ºqd8 èÂï5ó¼c†UpP­w oÙ=®¼¾+Ÿ²ýs¹eüQ_-«S–ªNѵùªS|ÑÖÍÆÔÝWº‹ÙÞ\§ã­£ãù]D|àæoÂùבôt't(š±’=:S.+VMБr&éYIÔ¤]F¬š;¡"Ê5CGTdXCPΘH´ƒPΨ²Ú6*:"Ë*Ø9íRÑ´Y¥ ˜©fÑf¼2t"¥›Å›VÓãÔ¦t–S|ËÏ3DwÚe®ÞjM;ý>ü(\i™éº5àp¿7"„ìÉ54zV™tßšº!#ʯI#Ñ´«ÜÁ®˜HñqTnzFŸ}÷y®¸HùÜE¹Ó¯³·æ®˜Hñ1NÖÖ÷÷c殘ËCÅ«GRè¼¢«˜ÉÑ%[ÌàO˜‡DÎÔ'ëÍDÙчÃjgw5Í6{xx.¬r‡5Í3ÜÂèÏ/Õ¿Š¸ªM…<›ÄJYW¢¡±â:Ê•2 „u3ȵÂ0ã½R2‘æ7ëËU# àëš´rÔØÀ˜dV¨â¨Œ[•Îk¢ ññQ¹ýk~ÈÿáhþÍ_Ë SÚÑŒ¼¿-æ¬û õν $”›Il“÷’é²iE×AäP@P@P@P@P@P@P@P@P@P@P@P@P@P@ógícû;蟴çÁü9Ô•¯Ã»Sðõó\½¼vz´qJ–ï)U}П5ãsåÈå@pŒ¹Õ¦ªÇ•¹~6X ê¬vÙù®¿ðäòËSÑ5=CEÖ´û­?YÓç’ÖîÂú‚{Yãb±° ެ ²°A¯¤vgëÊéæYU_gRu6ùc/uÆrjÒR[ÅkkŸhMû$xNä5ÃÛiþÍ_˜ÇÄ/¹‘ø#éÅX¯ââSÿ·)þ>¤¼×þ=ÍðŽïà—Ä™í¼þo C`t‹ :yµ6«˜b¶"Âîß¼ã;³ÍuÒñ?0Œ£í$¥ÕÕ¢®º«ÛK÷<ü'y­U3.—l¬!›¡ÏŽ+úk!ìP·ŸæÏØ|Y‹\MŠæVÒúnü>ï=Ϧü8Ù~õ™øNb­sÜ´Gù½:gÄãV¬õ=!†ÕÍvÓ>cµ;ëàWTOº:û#ÊÖÑ<º¨ÞF Ñ»œ©4N½©3H–c8¬Ù×MؽgŒ‘ßFF¬-Ò°’=z±³€b¹gÜÃÕ±µ½9®iÄ÷põ˜&Æ+–q=Êì_KƒY8„1,´—õ›Ù H÷¸ã­%ç‰(ÉqêkU‚¦$¥%ÀçšÖ08*âL¹§ÎNkx@òk×¹•4Ýy®˜Äñë×2'—'­tB'ˆ­vfÈõ¼QåÕ¨Q‘ýëX£Ï«2‹7ZÕ#‚r cV‘Ï&BOj£È]Âz{k™w2ñÖ¥³zq»9Û™ºóY6wB;wqךÊLô)S9KÛŽ¼Ög©F™Ê^Ý`k HõhÒ8Ëû¯½ÍsÊG±B‘Äê{šæœj…#‚Õopf¹g#ÜÂÑ)ü3ð$ÿ~.|?øgw/½ªE᳚(fŠÅs%ܱ´™PéoÎ ’ bBŸ/[ÙÓr>ó‡rï®béѶëé×ð?© ùs÷€ € ( € ( € ( € ( € (øWÑHÂWÏâ×r&•D²p6Šò&~‹…nÚ–‡loµ8r?wÀÈîȯ¶á|*…Yï7ø-?;ýçò÷Žùü±9´rè·Ë‡‚Ñ¥ñM)6šÕ§E®Í;.¯éÿ Ú¢,@ ûº1?”s*­¶} á e2GÇ¥z¸t|mQÙŸGèÐecUãëA\ø EEÛ,üFð|Cøcã¿$2ÞkZMÍ¥§öšî‚+¦Œù?ÊÄl—ËpÁK)@Àd Ã…úÞ­ /$Ò¾×¶äìÏS„¸ƒû>Áfw’”¹4“‚’çŠÕ_šÑi´šm=?š{fÃWâGú•…•™Ð[·¸¦¤ÃOCJ6¬dRœ‹¨ÜV-ð™r6éY´wS‘z6¬š;éȲ­Y´uFE„j–Ž˜H´Y´uÂE”oZƒ¦2,£àÔ´j¤]‰ðEC:"ÍX¥Æ9©hÚ,Ò‚lÍK6Léìfû¹5&©eàR¸4š4Lë,¯˜²üÔ=OC¾ 'ÍÅ&Z=CK¾Îßš­JÇ<èójz™}ó'Í[BG™‰¡£='N¾û¼×d$|î"‰Ýi÷ßw殘HðñÖÒûäë]‘ãV¡© —e±ÍZ‘ÎéXÒ†nœÕ¦sÎkù󜙳J9 ²Nâk µ$qú±ùq\õ_ y–«üqÔ>— y^¾>G5É3è0ýÖ×;ë4v3Ç5´!Ÿ"š2‘æ·ëɪ0‘È^µ¢9¦sòÖ‘8ª×#­oÊÄŸÐÿü_SÔ¯ÿfŸÚ_ê776ºoŒoml¡žVt´„ÚYLcˆ„C,Òɵp7HíÕ‰?U•6è;÷ÿ#ð^=„aš§fà›ów’»ù$½?OëÒ>$( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( €? ?઱ö©ª]KûQ|2Ðn¯®R xæÚ†™ÒbŠ;{ø *HH⌤å ‰žXâZâÅPæ÷ÑôÙiìÕê=:—ùÃ…öónPA¯"p±ú.º’º4¢—§5Ï(ž­*¦„r{Ö.'¥N©v9+9#¶BâIY4wB¡r9:sPÑ× —c“Ö¡£ª/Ã1^õ›GL&mÚÝŽNjZ:#3£µ¿ÛŽNj6ŒÎÇOÕÝ6ÔU™ÝiÚã ¿=Iªgy§k™ óÒ±¢gGºç¥+åØõ¦oãÍÂçQÉæ€8ÝFåNïš™-ž©Ì>~i™¶yÖ U‹š¤e#Œ¾Æj‘„ŽfäkDrÌÆ—¥hŽ*¦l•´O>©›(ë[Dòë“u5¼O*±™7zè‰äÖ3&­âyUŒÉ«xžUcê?Ør ëïÚáîgs4qjQê0ÜE•[ˆÖÆyB8yCăÆäSÔ ð¸³Ç(«IÅ7xµ¦Ï™j»;]z6ºŸ”x©•ÓÍxkFpR’pqº»Ož*ë³årWZÙµ³gôÿ Êù÷ý+ñïõVÊ)©u?”ç¼_á‹øOÅ2Õ¬æ“JÐtëNæ;dV‘¢‚&• ڇ3Üu­)ð•J“Pµ®ìveÞb3,e$”ªÊ0M윚I»&í®¶ON‡à×\-”h?…ˆþGú×õUU0j+ì¶ŸßÔþˆñ§/©ƒâIÕ›V­N6è”}žºox7¥ô¶·º_JxrOÝÅ_[EŸÎùŒ}æ{†.ä_^õéÒgÅcãfz¶•' Šíƒ>[ÏA°bBšê‰àWV:ûCŠÞ'—W¹» `šÐår//A@"t5 èƒ/DqŠÊHô(ÊÆŒoÒ°’=*S5 ~•„ÑëЙ­ ãÏ${4*XÔŠnœ×<¢zÔkX¼“{ÖN'|+–Vz‡ª8‹ {Ž:РLñ:¤ŸÞµŒ˜‚”³ðy­c‚®#C6YýëxÀòëb ÉgëÍoUj÷3d—žµ¼byukjS’Nµ¢G J…'|Ö©ÊÌÕ¢G4¤BÇóª0“!wÚ=éìFæl³õ©¹¬`cÝ\5gU8ÕÕÀ汓= TÎnîàsÍe&z4©œõÇ-ÍsÉžµ g}uךÂR=zŽ+P»Ànkšr=œ=#…Ô/8cšæœoDó½^ûj¹&¹*Hú% ´~—ÿÁ3~µÕ߉h?iÙHüÍÃ_i‡¿k»|îÛ¤±Iÿ?q°¯žÌkó?f¾gì|•ªTÞ2kW¤W·É4û£ö¼³î‚€ ( € ( € ( € ( € ( á¯Rðæ»àx‹Á~(²û‰t BãKÔlüÔ—ì÷0HÑJ›Ð²6×F”•8È$s^&*;Ÿ§äU“Qhé¬Ûî׋Q§`§¢=+ÁJLÏRz×ê¸:q¥+%¢ôGðâêã«ÔÄâ%y͹Iè®äîÝ•’»}©|5DuîÑGå”·>‹ð„’3Jõè#óÜÚz3èm>åzpÐølRrvG­ivÛšUj«h^_‚“•äæ«ö‰ðÇ€~<üYðÄÚ=¾•¾»u=žŸj#X¡³ÌöÁ3µÁ,D ÆÐB ~1šÑö8ʰµ—3²]ž«o&ôÇ€³5™ðæ_Šöޤ()IÞîq\³»–­ó©]õz¦Ó¹åöòt¯q?GÃU5c~•ÎÑìS™v6éYIÔæ^«Bœ‹¨ý+6Žês-+Ömq™:5CGM9Õ«6ŽÈH°­PÑÓŽjZ6Œ‹±¿š†ŽˆÈ¹˜ïRÕã#BºsRÑ´doÚÜôÔ´l™ÒZÜtªM:{+¼ùºRhÕ3¿Ó5m@4‹¹èZ^²åúÐQêZN«÷77?ZiØÆ¤Ñèún¬~^k¦…;Í;Vû¼×L*# w6: +Œ×Tfx•°¶füˆã$VŠgðæÌ‚ñÈ­TÎ9áØ—7ŠÃ9¥)ŽvêåNy¬¥#Ð¥MœŽ©p„c5Ï6zØZmu©ºÜ×,Ùô8dÏ/ñ&Æí\“=ü2gŒêáIcšÍŒò-y÷˜"™”-ÔZ£}êðkDsLç¦ïZ#Ž¡p:Öð<¬J?¡ø$pÇìããû/?ôƒN¯©Ê€ýD~ â¶ið/ý*Gê]zgÃP@P@P@P@P@P@P@P@P@P@P@P@P@P@P WJÒõÝ/RÑ5½6×PÑu y-/4ûèVx. ‘Jã"ù¢7ÜÑI!Ï“W†ãR÷?>¾—Ó¿•µ;2²ªùìxfSoÓ³JðrŠmÂëi¨§'§*³7?º|= ÀãšùéDý‚kš1ÉXJ'§J©~9=ë'ЧT¹•“Gu:…Ä’³hí§P¸’{Öm¨\ŽZ†Ž¨Ì½ÅOŠ†ŽˆÌÛµ¹äPÑÑ …JœñRѼfuV:‡Oš¤ÕHëlõ@1†æ¥£E# ·ÕO}ÜØ‡W šréÕNZÜçoõ çš lãïnIV$Љlão&Îê£)•ëòÕHÂLç'bIÏ­hŽY™SVˆâ¨gI[DàªgJzÖÑ<ºÆdßÅ[Äò«“Vñ<šÆ\½ëxžUc6jè‰å×GÕß°V¦º7ímð›Rlm‡ûS¨Ï]2í­yùÞ)`²ú•ßK~2Kõ?;ãüj˲,F%ýžOÆq_©ý#Â͇Ñ?ï‘_ž­0ò??×HyOñçâWß~3X™¸ðž¯œ£úÖø^%zôé/µ$¾÷cè¸C‹aŠâº‚·½^’ûêEχ‚.üäÈž\›3"Þ@+ž£œgÚ¿há{,<ãtß5í}®•¯÷¬øð§S8ÃÕörPT”œZR”g7.V÷·2¿¯f›úWÃRT«íh³ù‡2›=ÏÃÏ€=MzT‰ÌÙëLŸv»é³åqq=O~šêóø„uÖmÒ·‰åUGMÊ Û¡Á-m†‹š™Ùm“;!"ämÒ³hí§3JéXI­ ØÒŽ^œÖ‰éÒ¬_ŽozÊQ=*U‹«8ë'¶8‹yþô¹ V$c\{ÓP"X’£ÏïZ(u19'÷­#†­s>Yºó[F'›V¹BI3[(žuJ·(HüÖ©uI•YÉ­9g;•ÙºÕ¤sJD,Õf‘6>´ö3næ}̸ži6\#siñžk6ÎÈÀÁº¹<óYI´©œ½åÖ7sXÊG§F‘ËÞ]ðyæ±”N¾½ëÍsÊG­B‰ÆÞÞòÜ×<¤zôhœV£}÷†kžr=¬=…Ô¯#5Ë9æ‰Ïxwž"ø›ã_ ü>ð¿â ~ö;+mÉ#$;Í,¾Z³,Q®é$`§j#60 pb*ªqrg×dù|ñuáF Vÿ§èºŸÔ/ÿø{á¼-ðû¶þVƒ ÙGgdd›hù¦—ËUV–G-$ŒnwfÆM|¼äç''»?vÃІ”hÓ^ìU¿¯7×ÌìêM‚€ ( € ( € ( € ( € ( ã+ö¨ÓuMö¬ý£,õ6êÆîOë7iä- ¼ÞK42…` I"’9º2:°$kÊÅGV}îAQrBÏ¢<îÎO‘q^M:JµxS–Í¥÷³ô,^aS/ÊñÊ)9S§9+íxŵ{5¥Öº£Ú¼ jvÄÄw¯Ôp±?ƒóʺ´}Ká˜@òëÚ¢Ì3)î}áH”2}+× ÏsI6{Ά¿r¶”¦y”(áïy=ObÐ×îW4ÜÙîᣆ[šßðT¯ƒ——ÞðÇ JóWI-¡k—Qäxíäo2ÍÙ@1¤K)¹C!*KÝB¿>WoÄq-wÉm£ý?_½Ô^ 抄kå“•”­8-7JÓ×vÚQij­=5¿ã$Ò¾:hþ‘ÃÔ6!“"¹¥Ú£RèЉ«#Ò£3B6È‹G¥NE¥jÍ£®,£T4uÂe”jÍ£ª-#Ô4uBe•jÍ£®,#Ô4tFE”j“¢2.ÆÀb Þ,´’òKFñ‘«ØÇ5-©–×$cš†“:;[¼Í"Ó:>ÿy¤Ñ¬YßézšÄ‹e©¹ÞéšË³¡ÝŤz®—«ePîæª,æÄGC½ÓµO»óWDgcÇ©‡rÕ¾ŸªóüVñ™åWÃ,§Oš¶S<ú˜cr OŒî­Î)áµ%—SÊ}êndG fbÏ~XŸš³r;aBÇ5¨^䑚Ær==Qº?75Í9æ‘æýÏÍsKSؤ­¡äš´ø Í$jÏ$Ö§-¿ž)£)q~Ýyª1‘ÈÞ1Á­Í6`JzÖˆã™qÞ¶åâû±ÿ€ñ˜¾øwñ“áàÓ¶\µÖ¾ßçgÏûl/ËÛòìþÍÝ»qÝæã ·-ôÙDïNQ¶Îÿü1øˆ˜ue÷ø¢Õ»r»ßçÍø°U럞P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@…:<ÏñT×ußéÖR¿‰..//ì„[­ÜÜ3<‘ìrÙŒïaµ‰ã‚M~¡ÃÃØÆ‹W­¯UkjñNqˆþÑ«˜Ò›…^w4âÚq—72qwºiê–´ìùâšòËO¨øQ”®™¬²ÊØ-ö{Œ` @ "©e‡Hÿ2â©“Õæ½J[?ÑùþkUÕ/îOü^Áx‚öUmKI~òôkoiNú¸7k­eNMFM§ ÏÁ¡›=ëåå÷jÍ—¦ bâzTëc—¥e(ž…*¥Ä’²q;aTº’VmÔêÒJÍ£² i'½CGL&^Šr¤sPÑÕ ›]eG5 Æfŵë¨n*Z7ŒÍû=P‚2Õ&ªGA¨{5+)0jcŒµ+™¢51·ïRÌÛA\õÍÌ{›êERD¶r·’òÔÌäÎràç$Õ# 3|f­Ó2f5¤N:ŒÎ“½mΪgKÞ¶‰æÖ3&ï[Äò«“ujè‰äÖ3&­âyUŒÙ{Öñ<ºÚ£Ý¿e;ñ¥þÐ^¾cÛ¹úÙ\ë_1Ç<ßêö'“sÿNDüwÆ^uÁ¸ïg¿îÿôõ3öoþØÿç·ë_Î×ğׯûH|BÛðwÅ–Vú¹´¼Ô>ÏiÉü§œ4ñ™"\[tB]Ê:¦ìŒf¾›ƒè×­œQö‘æŒy›Òö´]›íiZϽºØý‹À,#âZ«Òö”àêNW2-9òIèÒå©ÉË'´ùlù¬|¢Ú4öЏ‰ÆÖoFãÈ×ô— UŠ­Z›z´ŸÉ^ÿš?²~¸ ÓËrÜdcû¸J¤ºÒSQqVÝÝBz¥emZº¿¹øZ\ì簯Ѩ³ø¿3†çºhRòœ×§IŸŽŽç¬é2ciÍwÓgÊbâz..Bó]PgÏb"v6oÈÉ®ˆ³ÉªŽ† Ïf´Lâ”SR6$dñTc§BÒœLÖ ²†³hê„‹HÕ›Ge9c’³q;©Õ.G!¬œNêuYu%ÀëY8ð­ba9õ©å6UØÿ<úÔò}aŒiÏ­Rœ± ®Ó{Õ¨œÓ®U’ozÑDã©\¦ò{ÖŠ'J¥G’´Q8êU*;æ´Hãœî@ÍV‘Ï)–ªJÆ‘ 8Zf{•$” óAJ&5Ôýy¨“:©@ç®n0 ÍdÙÝN9wsŒóXÉž…*g%{uÉæ°”Z#“½¼Æy¬%#Ô£Dâïïy<×<¤{T(œeýö7s\ó‘ëРq…ïSšæœn…ƒÔïðææ¹g#ÜÃP»?Mà˜ 4ígPñ¿ÇT[\Ï¥ÎÞÑ¡`®Ö“˜£šêr<£˜¦‚4t²Ü«.Ið³͵M¬ðnZ¡ bäµÙ~¯òKæ~ÊW–}ÐP@P@P@P@P@Pò¯ÿSð~©á?ÛCÅÚæ¡qk%§Œ4+Z±Kvfx Ku°+(*6ÂfK Œ‡9%W‡³êr:Ê).ßðçÄ:Tö Ž=k—-¢§Œ‹vÒï_Nž}~W=Î5Ì*aøn¼ió^|±¼z&Õùô‹IÅ÷rQ{ŸBø*lG ý Ïä,æ¶})á©9Œf½Š,üã2ŽçÑÞ<§Ò½z'ç¹¢Ô÷íç`®è¤÷>V´¥xžÝáè 8®LSQZAÂuæœÎãÅß|7ñOáÿŠ~x¾×Îðd±¸Ú‘¼î,ÑyŠê³FádÊ®ŠÀd ù ÎO2„o¢‚ÓÖR¿ße÷«UêP@P@P@P@P@P@P@P@P@P@P@P@P@P@P@YñÇX:Á¿ŠZ¤Zçö=äzòZjKqöw‚éát€Ç&AZ0˜!‹•’+|,=¥xB×»G•žâ¾¥–bqÜ®0“NöÖÎÖ}Û²^v±ùKðÚÆ!am"€£hPn+õŒW*?Ͼ"¯'ZI¯Ä†>ø­àûÿxËN7UÎ)¢!'²œxƒ²EÉÁÁV ¬Êk€¡˜Ðx|B¼_ÞŸuÙ¯øé´aÂ|[špfkO8Ê*òÕ†=c8»^W\Ñ••ÕÓM)EÆQŒ—àÿÅïƒþ5ø#â©|?âÍ6tÓ®%Ÿû'WeA«o…«±Ü#±š"ÛÐH»‡Ì¤þ-›äõòª®U£¿+î“ßFíÞ׺º¹þœxyâFSǹ|q™}Eí"¡íiÝÞœåÜ_4b䓼TÔyfã.W£KÎã—¡¼9DýJ•nÅèåéXÊ'¡J±z9k'¾bärÖn'}:¥Ô—Þ²q;iÕ-¤žõ›Gl*ÒN•›GT&]ŽR:†Ž˜Ì½í3RѼfjÁ>1ósRѼdjÅvÃj›©Þž>jE©Iy‘ËEs]y .Pžìœ€hfDòîÏ­4ŒÛ1§qÍZ1“1æl“VŽy³6\sZ#Ž¡Ÿ&9­bpU3¥ï[Dó+’÷­âyUŒÉ¿Šº"y5‘™5oʬfË[Äò«~º†ÇÅþ¿™˜}–î9ãÚv“*ÑŒàð\(þø|ß5a)½ ¨_}ïš¹§#Ú¡Dâïï~öMsJG³B‰Äê§Ÿš¹ç#ÚÃÑ3|+á?|Nñ¿†>xJßÏñˆ/c±¶Ü’2E¸üÒËå«2ņ’F v¢3c¸kÕP‹“>Ÿ*ÀOZ µoú~ˆþ¦¾x Ãß ¼ áo‡¾·òtÊ;8 $hóm<ÒùjªÒÈ夑‚ÎìØÉ¯›œœää÷gí˜zÃRkH«^}ÎΤØ( € ( € ( € ( € ( € (òþ ðšçÅ<ñkN†êk¿‡úÃCxxR4ýCËŠI]çwPØF¢3ÀšBT¹1¯Äô²ºÞε»þŸÓ?žmBÒÆ3ÁùW[ŸäÏ¥âÊ—á¼Jÿþœô?‚؃ JûŒ;?•ó•£>šðÃd¡¯f‰ù¶d·>’ð‰$§®+Ö ÏÎó5w¡ôG†âÝåæµ©ˆQVG(•ysLúÃP’¼ºø–ϼʲXÓi¦a¾Ïn›GSÚ¼y.yj~B_U¢¹w?ÿলØñF}ûFø<ÿÅE¢Ùňt¨-7FÑjÞ+F›Œ°£!•û<@îAÙ<¬Û.ö”Þ&šÖ+Unþ]oÓÐûßxÅ`±QÉ1Žñ«'É&þ5ðjíi5î¨ëÎígÍxþÛ¹8ɯ“š? °ÕÜÛ³Šå’=꾆‚6+Jœ¬[I+6ŽÈT,£T4uBE´lVM°™aZ¡£¦3'W©hèŒË(þõ›GT&XWô¨héŒË õ ™e¥£xÎÅÄ“ó¨hèŒËi&1ÍKFñ‘~ˆ#š–c#rÚä.98©hÙ3¢µ»5&©=ûGŒ5&:ëRO—E¦z•© ZCùÒ-3¸²ÖóŒ=JGWg¬tùÿZ¥# Ò]ŽŽß[Æ>zÑJÇ$¨st5¨d=>r~­a¯ªî¡Ìk sãU œµCw6>Cœ¼ÔÕU‰"³“;)«m¬jBF`"™çº•Òá©’Ï7ÕnU‹ ÓF2gxàîªF2g3xÚ´sM˜rô5ª9*÷ëxN%ŸÑßü³ÂŸ†¿e¯í«ùídµñg‰5 bÉ-ٙⅲ‚ ólfl)aµç$ªý^Y\:}Ûÿ/ÐþãŠê¶o(/±§ÿ¥iò‘úI^ò@P@P@P@P@P@P@P@P@P@P@P@yÿÆÏƒZUõî—ª|[ð]ž¥g3ÛÜÚ]köqKo*1WGFe`AdA­–¬•Ô½çÏ6ËéIÂxˆ)-sŠiöjå?ø_Ÿ¿è´øÿ ;þ;GÕë#û™?Û9oýÓÿÀãþbŸÏ#ãOöñÿ£êÕ¿‘ýÌ?¶rÕÿ14ÿð8ÿ™†ß´ïìô¾!ÿ„e¾2øLj_bûœu8¾Éåoòöý¯>G›ž|Ÿ3ÌÛómÛÍ?«VµùÜJÏ2×?f±½¯ñ+}û_Ê÷ò=Â>øôêÀ¾:ð÷ˆÍ‡—ö± êv÷ßeß»g™å3lݱñœgkc¡¬¥ CâV;hâ¨boìf¥nÍ?ÈìjM€ ( € (Ãÿi?_øóàoÄifs©µˆ½·†ÖÙ®e¹’ÖDºX5 ³H`Œd‚à€ØÚz°UUD&ö¿ç¡àñFY–O‰ÃBüÎ7VWmÅ©$—­óë±ù=ð×Ĭ,×~Fz~¿NÂU÷Qü-Ä8 W“±ôþšVêåS{×§ÍusáÝ>Yò•ü[ð÷Á¿ô ŸxãÖ΋.ãökèƒùNQ“̉¾ôrw "uÜpA®,^Ž2ʼ£ç÷]vzîµGÔpöm™pÞ%fV"Tk+kk¤Ô¹d¶”[I¸É8ÊÚ¦~þÒ³wˆÿg螺¼úŸÃNbºV¸Ê7#`·Ù®pYÕA €ERÊ‘þIŸd2šœÑ÷©Kgú??Íjº¥þ†øKâæ Ä,²«jXêK÷”ú5·´§}\µÖ®j2m8J:E5|Ô¢~ßJ¹¡½9¬eÑ¥X»¾õ“‰ßN±v9k'¾RÚKïY¸°ª\I= dâvB©m$¨hì…BâKïPÑÓ…ègÁÔXÞ34Vz–£2äw$cš›©Q]š•ŠR×]y¢ÅsÚ|æ‹ åIeÀ¦CfDòç<Õ$c9îjÎy2Œ‡­hŽJŒ¡)ëZÄàªÌékhžeVfËÞ·‰æVfdÇ­oɬÌÙkxž]c2jÞ'•XÑð–&­âÎ&Äži˜qœùjdÇã³N2~Ë 9y[ïÐ߇0Ÿ]ÎpÔ“·½ÍßàNvùòÛÊ÷×c·ñ23##¼œ#Õ q m ¾ñ>¹k§ë^ ‚ûg†µKÛMRîÏÊCç]Z¥ÄP>ò7‰}t6‚ù™`J©–1¿ao?ó>#†àžjæ÷Iþkü­ï‹°?Û™3-pçs„¹Uíy¥Í n¶š‹ÕÛ¾—á{28ðr0¯Ø(»£üãÌéò¶} Ì<¸Žz^­&|:³×tyw"s]ôÙòxÈٳѴé0×|ö"'qc.@®˜³Ä¯ªµ~oͪȘb¬äzã 2`qI£X²ej†ã"ʾ*:¡;¬•66B@þõ-F¡'™Jƪ¥€ÉE„ê‘—÷ª±›¨Fd§c)T g>µiNd,ùªHÂS¹ j¤Œ\ˆË~uFNDLØúÓØÏr”ÓmžiÜø¸ëÍfÙÙNÍ×^k7#²3»»Æy¬¥#Ð¥Jç){{ךÂR=Z4NNöûïsÅa)¥ Ôf¹å3Ø¡@ãoõ¼×<¦{0ç}Éù«šR=ŠBúû9â°”^…§¨ÞðÇ5Í9Ήú­ÿÁø×$ý¡|I§|‹æh¾ûL=Ok»|_îÛ¤±IÞî7âcë]û4~¡Âyr§‹šÕè¿Wú}çì•yÇÚP@P@P@P@P@ó¯ígðSTý¢g¯‰?´=n×IÖµë{v³¾¾žžÞê¨Ò]¿2£´6u P9`ŽWcLã̬m‡ª¨ÔS}ã²ÆÇUÐüAwáýwNºÓõ½:y­/4ûèZ í'Œ²¼RÆÀ2:²•e` ‚3\øH[ëù3ØâW>Cˆ…ïðÿéq>ƒðmÌjЧï_]‡gó®qM·sé ^m1®q^ÅfToséÝï–1»­zøy\üï7¥Ê›>–ðÜßsšìt£3æã«†z= <36L|×ŸŠ ©£ër<Òx¹¥}WšOÜ ÏjñcyŸ¨V«û˜¯#Èþ%h^6ðŠü«Ïq—¯é·Z]̶Œ«*C3‘» ×`bᇂÕõ?x¦¼1¾"pz]/œR‹üS>î³À ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ç¼Iâß x6ÆOÅþ&Òt=6i…¼wzÅìV‘I) Áä` F;AΞƪ•Gh+¿# F*†ÓQB;^M%V|‘âÿÛÏà–`²ø@ë,Ô¦‚f†+lbŠUËIä¹TdWcÑÇ)P¬JýÐÞ,§QûÊËÏþñ¹‡ˆY6 ?º“©-tŠk^—r¶Êþ‡È>;ýº>8xži"ðU¦—àý4L’ÄÖð.¡w°Gµ£’YÔÄÊÎKåaFUÉÃõh䔣­Fåø/ëæ|câ†:»k Òþ/½éoûu?3狊Ÿµ-B÷R»øËãe¸»™ç‘-µÛ»x•™‹‘Fê‘®OŠF+º9m­È¾ãåkñ®kRN_Yßi4¾IY/E¡ç—Z ßß^꺌²Þjד=ÅÍíÓ™f¸•س»ÈÙffbIbrIÉ®˜áãd¬xU³šØ‰9Ô›mêî÷~dGÃqž¨?*¯beý¤û€ðÕ¸çËúQìPiIõ+Í !1ô¤é {îeMá¨Û9Œ~U‰× É®¦Tþ· îOÔVn‚:¡šÏ£74üGð.Ÿq¤xÇþ&ðî•4ÆæK= V¹²ŠIŠª™"uÊ¢Äg a\õ0”æï(§ò=Œ'ã0ñå¥ZQ]”šü™Üø/ö¡ý¥þê/}¥üWÖõkyf‚[?Å3¶± ÂÄÄùy¸,ñ#†es ÆÌù²ªW’®]JfÞšE‚ã~ßÚ¹.Ò×óÕ|š>¶ð_üóÆ_g¶ø—ð›M¿^¯¨øböK/³Z¶ÚÌ%óe_Þ0ÌÑ«eWäÁsÃS*kà—Þ}^c+,E.»ÅÛOG{¿š>—ðÇüƒöhפ5ëÿxPZù~Y×´w›í›·gËû¸ÆÝ£;ö}õÛ»æÛÇ< ht¹ô8n*Ëq¼œ}Wù\û;ž6ðg4ùõx»Eñ•æÖ[Ý þ裘*±ž&`+¡*NpÊ{Šä”\]¤¬}*ÔëÇš””—tïù=#@ € üñ‡†Sá_Æ/ˆ­Diúf¨Íe¼ÒL°YÌ«qoy>r˱+OÌæo¼~ÿ)ĺÔ#'¿õsùÄ’9vi^ŒU¢Õ¯³Õ-{&“óê÷>‡ð–»löÐÛ½êké!YZÇ☬¾¢¨êXõ!¢ÊœƒÜQÔjg-âï xwÇÕü'âÍ" OÃÚœF«+€vȹF ²° ®¤2²†RMj±T¥F´y¢÷_×à÷[£\·5Çd8êY–[UÒ¯IÞ2[§ù4ÕÔ¢ÓRMÆI¦Ñø+ûI~Íþ#ýŸ|D²Fóêu)ŠéZã¨Ü‚ßf¹ÚY‚A,Š¥”#ü“?È*e5y£­)lÿGçù­WT¿Ðÿ <]Áx…‚öUmKI~òôkoiNú¸7k­eNMFM§ Ïçhfpkæ%¹Q®¥±z9½ë'ЧX½½+'¾bâKïY8ôëc—Þ²q;iÖ.$¾õ›‰ÝN©i$éÍfÑ× …¤—¨hê„ËÉ?½KFñ™ag÷©hÖ3-%É­MT‰MÁ=è±\ÂyçÖ•ƒ˜ŽIr:óM!9\äÕ#2³žµHÂl¡!ëVŽJŒ£/zÙYBZÖ'TÍ”õ­âyuŒ¹N3]<šÌÍ”Öñ<ª¬Í”õ­¢y•™èä²¶ñ}Æ¡ww³±–X $l²&p:ü®ã×Ô ãÍ¥%‡Q]Z_›ý¥ðþ•)g2«Q]œ¤¼ãÊMkß½_^-õÝÅÇ”¨žc5ÄV²>§ˆj*œÎÇœhl¬øÊÿQ^¦/ø(øN’Yœ­ÛõGé_À JÛLµ´»º,hýïjñV‡é²¼Ý‘ävöpè~'×t;qp-,o%‚wþ±á |¶n%“kdìŽ ~³–b>³BnµJöï×îgùïÇY3É3lVÒJœä£Í»ß+z/Š6i¤“NëF{O‡îw".yïR‘ù6>•›g²hsü«“^…&|~6ž‘§ÍÓšëƒ>w¸ÓæûµÓxµàu¶²ô­Ó<ª‘:iµG âj)È«z˜’ƒš’Ó“F©“¨±²‘ jM)iXÑL_0úšV8›éØ9Ø…Í!ÌŒ½UŒÜÈ™ýi¤e)‘“ùUXÉÈa>”ÌÛ!y;óOa$ÙB[Jæ‘“sty¬ÜŽštÌ ‹‘ÉÍfÙÝN™ÎÝ]ã<óXÊG}*G-}yÔXÊG©B‰É^Þ`7ÍXJG«FÎ6þÿïs\ò‘ìP¡sо¿ûß5sJG³BÆß_çw5Ï)Å yzyæ¹å#×£Då.îÉ$XÊG©F•µ9 Vi<£å‚]†zÿŸåšç¨Ý[ ók±ýg|(ø}§|)øiào‡c[Ioáí2 ¹µ´[E¼™Py×%$+Ë/™+rÄ´ŒK1$Ÿ›œœääúŸµáhG Fc´R]¾=ÏA©7 ( € ( € ( € ( € ( € ( ç[þ û&\|>ñü´ÿ€t»§ðg‰îÀñd6vp­¾…|DQ­ÉòðÛ.ÉrîÈqq¸´…®cAšýÝXÔ]õýNɶàªàä®Ü_*½®Ö±ûš]mmô¹ùÑở&Tç½}f~3˜Óç‹>ðýð&‚+×¥#óÌ} ]Hø÷uÄ#wëᥩùÖwFÐgÕÞ—&0+ÕŒ”UÙð5)J¬¹b}áEÏ—šóñu”Ñõü=–ÔÃÍ6´=ná?p‡í¯Þ?SÄÃ÷1ô<ÿYFù‰ë^ÆŸœgz¶:ÿðP‡ðƒü}¿ñŸ“¢øÂÖ=R3—ÙàK¥ýÕÄaÇË$…£Yän7CpÉÜßÅ?«ã]D½ÚŠûY_gêú¿]{¿êoxûg†#ƒ©;ÕÂIÓwŸ4œ½Mµ¼cféÁj­MÙéËŒ-äÜ:ò+åg¾áªó#N'éXI­*–.#æ³hí„î\«)#¶œ‹Šx“;¢ÉCT´m£T´tBE•5›GTdN¯RѼfN¯PÑÑ–ª:c2uz†ŽˆÌ²’~u-Æe¤“Ö¡£¦-¤•-ÆEèn sRѬdlÁyÓžjZ5R5â½'5-©ö÷¸#æ¤h¤u6zªÆnæ“E©®³Óç¤ZgAo¬tùè*æ¼ZØùÿZrÏöÐa‚ôÊRêy'æ .d]jYÈÝÅlå¯/9<ÐCg#{9bÄš¤Cg-y7šhÊLç.9«Ff4íÉ«G,Ù•1­bŽ*¬Ä»}ªÆºi«³ÁÆTå‹gö…àOéŸ|àßè³ÝO£økJ´Ñí&½ey¤†Þ…FUU.U$*Œçt¯´„T"¢ºÌøŠÒÄÖiï&ÛõnçWTbP@P@P@P@P@P@P@P@P@P@!ñ/öŒøAðžâãLñ_‹"oE’ L®îË*,‹¢!gYgœÑ«nÈ8Žª*øiÇNý?¯CÁ͸›+Éo]d¦“÷V²Úö²Ù»«sY>ö¹ù÷ñ#öàø©â›ÓmðÆÆè1K˜îîaŠúúíAâEhbVVŒ˜ÕY•“‰YN+ÞÃdpнm_Ü¿ÏúØü›;ñOVnjTâží)Iï½ïum,ÚkâhøÞ÷OÕ¼Eª\ëž$Õ/µ}nçoŸ¨jws<ÛT"ï‘Éfª¨Éà: öéácMrÅY—ãsÚø¹º•ª9IîÛmýìÕ·ðð@P>‚º+5LÁÉšèkýÚµHç–5—ÓEP2R«Ù˜KßQÿØéýÊ|‚úÛîG_î~”{1<[î5ô•îPéŽ8·Ü§&’§•.™´qo¹Mô`z¥O³6Ž1÷3'ч?-C¦tÃbÜh½~ZÉÓ;)ã K9;+7Hí§Ž·S›¼ÐÆɱ•3Ñ£ó9ï†ÝòøV¤zÔ1öê3ÂZç¾xŽßÅ¿é|ùÄ{Ÿì“šMŠc †‘‚±;•Fø ëƒT!,F^Û¶¼W×á}m¥“Õë«vGõ߆_IIbqTrž.ŒaÍî¬D}ØÞÑKÚÇhó>g*‘jm~îRšüÖŠà6sï_Ê?²©bTµL¾“tæ±q=u˱ÍïYJ'}*ÅÔ—Þ²q;éÖ.Ç/½dâwS¬\I}ë7¶KI'½fâu©i%÷¨q:ãT²’Ô4o…„—Þ¥£hÔ&{ŠV4Sæ}(°ùÆ—$u¢Âr"vì)™¹]û ´Œ%"£š´sM”¤5¬N¬¡)ëZÄó«36ZÞ'•XÌ›½oʬfËŽkxž]feÌx5¼O*»;߆–†K­oP Ì}ííœçÛËý}«ÏͧhBÝßîÿ‡>ÃÃÜ7>#Šæø"£nüÎ÷¿—'moå­¿·úÏÆ¹ð«Tzùì½É>ðv™}ðÃÇß帺Ö‰â] E‚u<¶º¼Ò³®ÝÅÃi°!€¤ÈbT¯«ŠW¡?ó> "ªÖkËѧø8ÿ™íž oMofl&V¶\|ŠE|ÝI[Cöœ(ów;ßizÖ‘â+˜þKØþÏ#¤;@•9RïÝ™ qp8û~ÆóÂxvõ‹º×£Þ˲‹?—~‘\5õ|V8§v¬\&Ôt掱r—YJ.É=yièÚ^ïMáË­ÞSÁ¯Ð(ÈþAÌiZèö½ã”¯F›>3OsÔ´ÉC*íƒ>c6wSco5Óxµ uöRýÞk¢,ò+DémäkX³Ï©šñKšÑ3šQ.ÜPÑ)4­&¤µ!Ûþ´¬W0»ýè°ù„ßNÂçZšD9‘’i؇!ŒÀL›ÜŒ½²'” <ÓØ”¹Œyîy<Ô6t™—5Ö桳¢4îaÜÝõæ³r;iÒ9Û»àæ±”B•—»Ô1žkHôéP9+ÝC–ù« HõhÐ9 íK9«žS=jc‹¿Ô~÷Í\ò™ìÐÜmõÿQº¹å#Ø£@äoosžkžR=j4lr÷WYÏ5‹g§J•Œ•V¸/8ïQ¹ÔÚ¦®ušG„fÔîbCÉù¸íé[Ó æÏ+›G î}‘}¯üañV¡¡ëú߯kLÒÿ±¬î´ÝZK-­IFu߯‘äx¢i$»Èc{6Ä ÓO%ÃÙÞ;ž./ÄÜãš*5~dõ»^vjý5ÝÚíßSÓtÚ«ö±ðž±q=ÿŒôŸZ<&(¬¼A¢[ÇbÊ|ÐÖkÀv–+ó‚v°â«SÚ:O€ñw×´ª”»¦–Ÿu›ûín—=_·§ÅÝ>öÃþ?ÃOßé-q"ÜÏá©g³• fƒcF“<¡Þ4[¢U™¦H†èDlÒqÔáú‰7 }çÑ`¼^ÂTœcˆ¥§WúlŸÏ¯mt×ô{À~üQÓeÕ<â›-^މℴsڒΫç@ád‹qöïUÜ##šðëP©‡|µ#f~«—fØ,ÚŸµÁUS^[­ítõW³µÒ¾ëC½¬O@( € ( € ( € ( € ( € à¾)|6ð¿Æ‡^2øaãKO?Ã^$°–Âçlq‰ðN¨#š3œò;×­†™ùöu…æ‹>Îð…âÉ×p½•OÚÇsóGŠú…WxÝMxRè~î¸1NUv}nOÄ*¬”`‘ë|¯Á¼¥JÒ?@–`ªRG ­\š½\,€Ïq+SáÛ àtß>ÜØhVpIãÍa£4­FVé-¹•”•Y#Îr)–8K°U&Œó*y¦’šýäuŽß55讕Ýü,ãøð/¬F2m`ë.J¶MÙo ò¦®á-ݤÕ9TQ‹”‘üù]Z_èú…晩ÙÏg©YÊö÷—Q´RÁ*¬ŽŒV  Œ‚5ù-Zrƒpš³Z4÷LÿC08ÊXŠpÄaæ§NiJ2‹N2M]4Ö5ªkF‹QKŸ­rÊ6=ÚU¹›¥c$zTf_FÆ+B±e\Š†Ž˜L_5 ™:µCGL&N¯PÑÑ“«T´o“+Ô4tFe…z–ŽˆÌ°­PÑÓ“«â¡£¢3,£ûÔ´o–QÏÔ4oV@1ÍKFñ™r)qÞ¥£xÈÒŠàŽ¦¥£XÈÔ†çÔÔ´j¤l[Ýtç4Û{Üc‘i›°ßð9¥b“/¥ÿûTйi/¿Ú .$š€å¨ ™êç‹ æEÅá óUb[9ë› wsA›‘ÎÜO¸ŸJ¤Œ¤ÌyäëV‘Œ™“+çš´ŽJ’3&n kpV•‘￱?~Õ?´M"{XníüIk¬;]³*líÓ(*¬w˜­¤ 1‚åA* aéà çZ w¿Ý©ðüWŠŽ,¯)u‹_øº¿3úÛ¯«? ( € ( € ( € ( € ( € ( € ( € ( € ( € (Äþ.þÐ? þ -¥¿‹/îg×®âóí´=*>êx¼ÅŒ¿%R5˜ƒ#¦á72•®¼. ¶-þíiß¡óùçå¼=ñ“÷šºŠÖMm¶Éy¶“³¶¨üÎøµûTüQø»c¨øn–ø!ûg|yø tídø¯áý·—ü#^#‘æð/’»-.Ö[íŠ.4ËÀ›Ù¼–5çWÀÆz­öYg×ÃZ2|Ñìþ[>ž]<Ö„¿ðP¿ÙÛâE¶•iâ?ø¶ç1˦x ­‘Ö,Œ·à}ŸÉÎôF•¢w)þ­K >eL-J}.¹Ágø,bK›–]Ÿùíù?#í½KMÓµ:ÿHÕì-ï´›è^ÚêÊò%š˜]J¼r#IH ‚A®tÚwG±(Æqq’ºgâ7Ç„¯û<|Q‡BÓ£øqâ/2ïÃ&[Ãs,b5í6ÒÃÈ» nÌn™‘ÜI¯Ê1þÞÎoÞGó—ˆ|&²¬KÅáãû©íåµ×ɽ<­«w=§À,ú=°f Z ü{ò?C_i†¸ælî§ûLíÑÛîÐô(•IÝ#qé[I½‘åÒŒ[¼Ù¯’cl0W<¹“=š^ÊPvfdÑrHÆ+xÈòkQÖèø¯ö‚ýü ñn-CÄ~Ž |Fò¥xî¬âX­59ÚO3uìj„³122aÿy¹¼ÐŠ•ó¹Ï a³DêR\•uÕh›½ýåo]Vºë{$~ÏᯎYçT§ÇIâp7Šq“n¥8¨òÚŒ›²IrµN^ç»hû7)HüsøðïÅÿ <_¨x'ÆÚwÙu{lç÷iêwÞ }Ÿ³ŸÅþzøûÂÿ)Þ&¯Z²½ò?>Ë'ìóhzKô=?ᦵ„jXnlpkå1Q³?ȪóRÔúoÆz|^.øi¨¼,7šA¬|…Y<¤mêß)'1´˜6Ü3^—c>§…öŸ»÷µoÆ×ò¹ñž1pââ.Ĩ»Oû孓䌹“Ñ·î9r¥o{–í+ž;á›±ä¡Ü8<jýŽŒ´?͜ʗ¼ÏmÑ.²æ½r>/J×=oI¹Tf»éÈùL]-NæÊnœ×LYâVØÙN5Ñy t¶ÓçÖ©žuHXÚ†ZÑ3’q4â”qéV™ƒ‰dò(h”Çîõ¤ZbäP>aÙ>´¬W0›½è°¹„Èõ¦Âô —!2M;r¼¯ŠED®óh-Ù›qsÁæ¡ÈÞ3 {žO5›gl)˜·7|k7#®#žº½À<ÖR‘ßJÎVòÿ¯ÍXJG©FÉÞßõ« HõhÐ8ûýG¾jÂS=zsŒ¾ÔzüÕÍ)žÍ 9Æßj{æ®yLõèáÎRòôœóXÊG«JÎOrXZųЧNÆk‘¸Σs¥5vÞðü—sFY23“ÇS]4is3Å̱ê”ZLúŸÁ>‰L_6=:Wµ†Ãõ?0γ{û·=«JÐÕŽHÿô¡JÚ3ãqXÖ×4Y§{áÈ áãg#Š©QG-ÆwÑœíç‡â‘JÆ=1YJ’g£G(»ÜókýUðî­ˆü3©Þé:å¶ï+QÓ'{i£Ü¥lˆC «2œA#¡¯;ƒDÔ•Ñö9'×ÂJ2£QÆKf›M_M×Sôöiý­®|M©Úü8øÁ}x®òbšWˆLQÛè»7Ëm2 TŽbN# “„âM¾wÇfy_ÕÿyE{½Wo?OËòþ‘àn=þÙQ̤½³øe¢æþëJÉItµ¹––º÷¿@kÄ?R (äÏþÝŸ²€?³?·>>x^ïíþg•ÿÔ²kÛ6mÝæý…&ò³½vù›wa¶çkc9V§ÙÛK.ÅVø)¿žŸ…¢ßSž· a'nKÇÑÿÏsðWüKâ‡öŸü,_‚þ×wùcÿ„oP¹Ñ¼Œnó<ß8]ù›²›vìÛµ³»pÛ¬sö‘Ã[„#§²¨×ªOü¶>ÁWe¿ifoÝëÞÖ`‚ݦµÕ´Éµ&Ô™RÚk5•#eÆùc„°u!~ò¯L1”¥¾‡ˆá¼uî%%äí÷Þß…ÏÐx÷À¿4Éõ¿‡þ4мO£A;ZËáíF Bæ ¬ci"fPá]©9éî+¦2RÖ.ç‰VJ/–¤\_š±ÖS3 ( € (ðSþ ½ð'þßøgöƒÑ Æ™â/F×>o¹¨Ãû<Ÿ4„Ÿ6Ú"›cQ>Ç–%¥ç» ;®NÇËç¸[IW[KGëÓï_—™ù•á½Pì [‘^­ŸŸf8mn}á O3º½\<ÏÍðÛŸo|?ÔÒ[;l¸Ü1_G†âÆ3Ì;§VZRøjø,hAÉ®ªðçŠ< §ðÕÚ=:ÒúY6ª‚Ià ñêQKV~‘ƒÌ*T´cÔÌÖUòÌz{v­ðÍVy]³¹?9¯bšÐüëýö~HÿÁHþXÙÏà?ŠO‡à‚âúY´½gU…•æPˆÖ‹"g,Â8¨ªÍ¯ƒã\bébá 7u'ßEË’zöV}ë/£V¯wbk¹F 5(ÓiµóIVqvÑsJ›ånÜÒrŒnæÏËØ$Á¯Ï¦ì =K3^'àb¹¤j”î_ýMe$zªÕ«6ŽÈÈ™Z¡£xȲ§5 é‹&SPÑÑL¯Š–ã2uj†ã"ulT´tFDêõ ™:½KFñ™:µCGLfYI*7S'WÏzMFe¤’³h錋‰.;Ô´mcœŒ`Ò±ª‘£Óõ65R4á½#<Ô´Z‘­þËR-H¶š€=è*åÄ¿ãïP;Ë~Oññ@\¦×yïŹJ{®4ÉlÅšrÄóÅ4fÙ“,¼ŸJ´ŒdÌÉdÎj’0œŒé_µh‘ÇRF\ïÁæ¶‚<ÌDÏÙoø$Á 3S»ñßí ¬-­ÍÖ—;øgD…‚Èös˜£šîr­QÌSAn’²[•eÃ)?C•PÑÕ~‹úþºŸŽñîi)J=>)~IoêÚkùZ?s+Ù?6 ( € ( € ( € ( € ( € ( € ( € ( € ( €0|Qâø/Ãú¯Š|SªÃ§hlFk›Ë‚vƹK1$*ª‚ÌÌA$ ºtåVJWlçÅâè`hK‰šŒ"®Ûþ·è’Õ½§æwÆOÛKÄž+:Ù#Ã’ù–¿ð”ÊÒ-õÔg`ó-“åû.q( ÛäÚêÃÉqôx‘i:ú¾Ý>}ÿ­Ñø¯x£'Ï…ÊW,u^ÑüOmb¾Ï]]Ýš~ë>9Mº¾»ºÔoçšëP»•§¸»ºÉ,ò1,ÎîÙ,Ä’I<’s_MN‚‚Qв?Ææ•1%R¬œ¤Ûm·vÛÝ¿3¦´ÒU1„æº#LñjâÛêté§“ŠÕ@àž#ÌÔ‡N#VŠ,ñŠXcU(œò®ZK;Ur™:å…²ã¥>S7XØý¨åµYû~TùDêˆÖ~ÔrV"k?j\¥*ÄMf})r–«$³ÿf¥ÄÖ5Š2XîÔ¸›Æ±FK¼T¸›F¹•>Ÿ×ŠÍÀê† Æ¸Ó³Ÿ–¡À질0î4ÓÉÛY8Ôñ'9y¦d–±”BŽ&Ç+y¥uùk@õ(âŽR÷HëòV¦z´q~g!}¤ 7É\ò¦zÔ1~g ©h îù+štÏoŒ·SÔ¾þÓŸ´ÀXm´ß‡¾=ºO Ãñ΃ Ú˜¤Ž×QTAw¦³•&Kiˆ&6Ýdò¶ÀYr§—a³:Nž"7ìú¯4úl½vwZI¼eð.>8ìž»ƒM9BïÙÔJë–¤JJÒ’]cvàã+5ø×ûDþÉÞ1øöÏé³ÿmü2{¿*E2ntäm¾X½@¡W,Æ1*e”dFÒ"ËsÞ­•^µ7ÍJûõ]¹¿+­•Ò?¼¼(ñÓ,ãÞL³a˜(ÝÅü¿3¤îÛ²\δ¢›³¨¡)¯”ã¸þ5ò’…èX”ËñÏÓšÅÀô)×.Ç7Nk'ºrìsÖN}’ðƒR%ž.œô¯c‡±ùÖoœ96“>Žðž-ϖѤpq^µ[CóÌÓí5¾§¡G§Ä£w–+­E «ÉérIlR\œsCŠbY@ûÒzüµœ uÒÅŽ«£ùÑwø×ÿ{øÅâ›ÍcIøá}/Á~|Gi¬ê°®¥«ü“–bmbó!£BÑO°™6ÊÄ«/ƒSþÉú¾‡#£®îû-¿Ïò?4~#üZø«ñ“T]_âŸÄ{Ä÷qÏqsnš½ì“Cbó²´¢Ú ùvèÅ÷q* €@ãyKv}.,£AZœþ¿€[`;V.¡éC ‘a`•gL0éˆF:T9ÆŠ$J\ƪñµO1jˆÿ+Ú—1~Év+ÚŽ`öH<ª9ƒØ¡†éO˜™PDMµR™Œ°æŸ‡µÿø3[²ñ7ƒ|Cªh>$³ßöm[E¼–Îæßz2>Éc!—r;)ÁV ðMk ®.éœ8Œ:ÑqœnŸsö¯öwÿ‚»:/Âß´¿…²?woÿ dž!ÿ®1ù—–9ÿ®óI%¹þêGm^¥rzLølÃ…§Nó¿“ýÜ•þlý—øsñ?áïÅß ZøÇ៌4¿øn}«ö½2q'‘#F’ùS'Þ†`’ÆZ)È»€eŠîŒ”ÕâÏ“­B¦|•bÓóþ¿»ª2 ( €>vý«~ Ú|vø ñ ÀÙ?oñ XÉ ¤f•5HÉl#–`V/1Ç’í•>TÒ.å HÒ”ù&™ÉŽÃ¬M SµßO^Ÿåè&ZMÑ‚}¹àׯf~u‹¥Ï žçá=]P®p}ÍzT*šá®ÑõÏ€|F‘Ue qÆkÞÂÖ±ùF{—¹]´}àýiŠÆYÆÎù5êûI4~õJQŸ™ôÏ„®¡Ïn˜¥xøÚ4º£ðÆ3Œ¥/ŽÚ ¬YKóñÅi†ªŽLïS]/½P&`}ëÞ¤ýÓòltªÒ8_x/Cø‡àÿø#Ä–þn¬ÚIi6ÕFx·–H÷«(‘k£;]»Tâ°Ôñ”'Bª÷d­ÿ_ªÝvfÙw‹á¬Ó›`%j´d¤µi;or´Üd¯¤×4[[3ù“Öô]SÃî³á½rÛìÚÖ•w5å¾õ&xœ£®å%NHÈ$pM~Z”èT•*ŠÒ‹iú­þªe™†4ÂÑÇá%ÍJ¬c8;5xÉ)EÙ¤ÕÓNÍ&º¡I‚é\“‰ôz–ÑšHÝ0kR±i$íY´u¡e¡£ª,£â³hê„ìNõ:îH­ÏZMFZ“«b¡£¦2&RѺ™2½KF±™a_Þ¡£¦'W¨hèBez–ã2u|T´o–VQPÑÑ……Ô´o–R_z–£2ÚOŽõ-)—#¹564S.%Ͻ+)ÒèúÒ±JEyÅ+˜CwëNÁÌFn¨°s$œž¦™E&÷¦‘Ft’j‘Œ¤R‘êÒ9ç#:WëZ¤pÕ™y.Õ<×E8Ýž.6·,Yý†þÏŸ ø'ðOá§Âèá¶ŽïAÒ¢ŠüÙO,ðÍ~ù–îXÞ\9I.d™À!pªQöiû*q‡cùÇ2Æ<ÃWþÓv¿m’Ó²²=޵8B€ ( € ( € ( € ( € ( € ( € ( € ( € (Àþ7~Ðþ ø#memªCqªø¯P‰ä²Ð´öQ!P­¶YÜœE ‘BoÃ1%¶£ì}½¸<\k÷4Kwýu>_‰x³Ã4ÓÄ>j’MÆ wæûFú_W½“³·äßĈ>8ø×â Oxîêö‘lôÛxí,TíÞb™ˆge ÎÌÌpvª*ýž .§„ ¾}Oæ®'ã,o×U1I%e¤W{+½_VÛ}6I,Ý?ETìý+Ô…3àñÖúM¾š>ZÙ@òêb ë{£îÖª'J÷4ã²Î8«Q9eXÑŠÄqV¢sʱmm¥W)“ªXKAéO”ÍÕ'û6?†Ÿ)Ð>ËþÍ¡í‹^>í¨1­½¨°ÕB#kíK”¯jFÖÃ(å)T*=¯µO)ªªUkAÝjyMUR¤¶kŽ”œMcY™’ÙŽx¬ÜN¨V2å±Î~Z‡¦Ì›‹ËPâuS®s×Zw_–²p= XƒœºÓ3“¶±”F–&Ç7y¥`–±”FŽ(ãï´ž¿-sÊ™ëPÅuþ“÷²•„ {1^g£Ÿ–¹¥Lö(c<ÎRЕƒŸ¥sN‘îañÍu¤xÃÄþm64Ÿíº~žÑ}– ¼—³y<«y¿ÖC=ÝôHÂ7y7º3*‘•&ðÕH£·g8I`ëJÉõ²vߺz]Ý¥k÷>Óð/íáÉÖÚÇÄú}Õ¤ÊYÏÍ“ßi{ûsÅ}>>§+Fª±ønuá.6“•\ Ô–¾_o•Ï«´ÿŒß®4øomüC¾j±H"Fi ùHÆœ€ ^ {QÇáÜy”Ìêð–qN³¥: Z×m«k×ÏÎɵØê4Xx‚í-ì"qAÇŒôÇ~æ´†"5]‘ÇŠÉë`az_-J°6ò€ÞJ¬š/JM‡ÝÀ¡É"Šsº7 £;£9ÐVéžeH#á?Ž_°Ç€> [¾±ðÖø¹7;GknFŸˆ‚¤o¶ÿ2'ï"_â²HÄòy¿ á1ËŸ •9ù/u颷OT»Ý6@xyôƒÏøRk žJXÜ+²÷¥ûØ{×””Ún¦û•%Ò 3§Óü­ø£ðSâ‡Á‹ãmãÏ Om§4¾M¾µmûû²LvN¼e‰ÜFûe 2ȹ¯Îs,“–J؈iÒKX½úùÚövvèhðWŠ;Ç4TòœJu¼©ËÝ©#{ÁêÔ\”\ãÍO›E6y”Wï^4 ~•GrôsûÖ.¡O^ŽzÊP= X‚êMïY8ЮZI½ë7®Ë+7½C‰×Ä¢_z—eTISÊhª‹æ ,7Rã ÓH‰T"f÷ªHÆS+HÕ¢G%I”d~µ¬QÁVf|­šÚ(ójÊæ\ÍÖ·Š<šò2gÕÓž6"ªW;Oi¸ûFµ:c¬Pn÷Ó ø ÿxW›šWÚ„}_è¿_¸û~Ê®çšU_Ý…ÿòi+¯ûu4ÿ3©½nµçR>ÃÖ§¬Éò°ëac©ùîySÝhþ„e…ú­ÿñ¥†‰àßí}ÆеYtåïäÔµxdº·´’ïß/ØlDk‚$…FòXû±é4~WR³†>3nÖkîÜü$ð}ã$°íb=«å1qiŸ¿ðõXÔ¦®}©ðÿP@Kúu¯*¤O¾ÂTìQøµá‰íµÆñÖŸyçZÞRúÞFÀáR$tõR‚:†9ä1Ùö¼)œGÝËê+=y_}ÛOÏvº[Ïæü9ªÝ^.ÂOš‘U‹²qv8Ê;^/Ý‹ZÉKUx·É‡¯ò±üÜŽµúM)Å… Yíz5ÈtFÍz4ä|f2—+hôm:è £5× ;ˆ¤w6S×LYâV…Ž¢Ú|Ín™æÔ»mqÓšÑ3†¥3v ÆMh™Å8I>@Á­9Ü,\IéÜÍÄ›Íã­;‘ÊBeù©[B_83Næn7 –àÁ¤Ù¤`R3uÍMÍyJ²\žj\#LÌšë¯5.GD)™€gšÍÈë§D¹¾Æy¬œŽÚtfïPÉ?5e)•*7w¨c?5c)ž•,9ÉÞê@ù« Lõ(áŽ:÷SÎrÕÏ)žÅ1ÇßjYÏÍ\ò™ëPÃ…î£×æýk LõèáÎ^êô’pÕ„¤zt¨ØÃšrùÅfÙÛ$@ó8ÀÎzRJá9¨#Òü9áç›hÙ’ÝMvѤÙó™†`¡ÔúÃ,GÊçŽÕêÑ¡cà3,×™µsè@ò­‘¶rHêS¥d|3Ï7©éÚVœ Ur1í]p)ó؊Σ²6Œy=*ÎU ‹5;« 6ÂóQÕ.à´Óm"yî.î¤Xâ‚$™ÝØ€ª$’p&¦s8¹ÍÙ-[{$V _^|4êM¨Æ1MÊRnÉ$®ÛoD–­è„þ'þÛ¿ <+u¨i^´¾ñv±o…X•·°i¥>ÒÙf©pñÇ$m”ÃrJü†cÆ8 #p I.ÚG}}ç÷Ý&žšöþàÏ£çð§‰ÌåtåVÎ)Åû5d®Ú‹ŒêBq´¯›¿>:|Oø¹$øŸZ[m ±ISmiüæ\–—æ\y¬ûX»AÅ~y™ñ33º«+GùV‹§Íí}[³ÚÇö?ø=Ã|£SCžºÿ—µ-*Ÿkgei'ìãhÛ›™«žMšŒ|µàÊ¡úÅ<] iljÍÔ;!…±i`•›™× =‰Ä#Ò§˜èT ‡Ú§˜ÕQD¢*—#UDw”=)s©J9ŠT‡y^Ô¹ŠöAåJ9ƒÙ ò‡¥.`öHCµ>a:# >ÔùˆtHÚÕ)J…ʯn§9jl䩆LúöVý¬~!~É^'×5oéz^±áÏý’=oCÔЯÚã‚FehgOš‚KpŠÄl$JŒñæ@¥ƒ†Eö©V…ex³óL~Y‰Ë§ËZ:w[?Ÿ-þGÒ5©ç…P@ËíÑû=ê³ÿÇMwÈ·¶ñt÷:îƒ&›bÖ–Ö°É;—±UËnYWld-àbÌØ¾• œñóGÄæxG†¬×Ù–«ü¾_•™ô=U–H•Û¦kº”õ>W…M6ð‡‰ÞÒhVIõë^¥ ܬø<Û-UbÚGØþñôrÙÃåË€Ï5îÇ¥òºÙ,¨â½ä}uð¯ÇÛÁ÷3……FX“^N&£›åGèY6h{iè‘ìwÞ ‡ÄÉ=¢íèzµvàé{;_s帓õ×%MZ ñ<æ÷™ž¾†—Â~;Žþ+3ësÍzŸ–_´ÿì3â/x«ZøðkÈ»¸Õå{ÍOÃw·B)ZîIyme„ÚåÞFIvm…ƒ,iðYï Ô¯ZX¬¼Ú¸·­ÛÕ¦ô×v›VéºKúÓÂðY^]G"â‹ÅQJëF7³Œ_,jF>õãeÊ—2k'N_•÷–—ÚUõæ—ªÙOg©ÙÊö÷—Q´RÁ*¬ŽŒVVFA5ùíJr§'+5£OtÏì6–.”+К9¥(Ê-8É5tÓZ4Ö©­¸ã5„¢zÔkã|óY4z4êJÉÄí§T²¯PÑÕ“+T4o“+Ô´o“5-FL•Z¥£hÉ“+Ô4o“«T´tFdêõ ÆDêõ-Ædêõ 1™:µCGDfXW©hèŒÉÖJ–£"Ê?lÔ´m’J›)“,Þô¬j¤XY½éX¥"uŸÞ•ŠRÏE‡Ì3ÎÏ9§as<¾ôX—"£Éšv3r*»Õ$c)X£,™úV‰•&P–@5¬QÁZ¥‘÷wü{àf§ñwöˆÐ¼is¦[\øáÌñk¤“Ý´.·ef:zĨw»‹˜V\G¶ÝÓ¹ROc-ùÔR迤~oÆ™´pØ9POß©¢ôÓšÿ'núéÝN•ôGã@P@P@P@P@P@P@P@P@ñ'íûZéž “^ðÃlßü@ƒójÛK=%Îá É'͸ 6m(¬ß1%#íeÙDñ6©WH~/þãÛ¹ùx‡‡É#S|Ø…£z8ÁëY.ÖåMêÛN'æ…–—=ÅÍΡ}<×z•ܯ=ÅÝÓ´’Ï#±gwvÉff$–$’I&¾ÎÓIEZÇó>cšUÅÔ•Z²nMݶîÛ}[êv–:b® \šëŒŸ­‰léí캵º‰æT¬mÁd2+EŽu®jGj8À«Hå•BüVÞÕIJ¡}-Ž:UXÁÔ,­¯µUˆu lj|¦n¡ ·§Ê/h;ìãÒŽQ{AM¸ÇJ9EíÃô£”¥PŒÀ:b—(ÔÈšØÔ¬R™YízñJÆŠ¡Y­}©XÑT)ËkœñRѬj”$´ëÅC‰¼j™òÚãU¬Ÿ/Ù³‰HVßçUJ ‰Î8>–#š¾òËWËÑù/åëÝ^ËÝGôÿ‡Hü~Sì2Î)¶ ­n¯í"µ÷ª-}­½ÔÜygÊœŸµ›×òçžñÃÝr xß÷ú.·ãökøŠy¨“̉¾ì‘–G "FÚpH¯Î±˜ ø*Ž–"2óû®»­7Z>çögñfWÄØH㲜LkRvÖ.öm)rÉo$Óp’RWÕ#;€{×  }],MËÑÜzšÉÀô)âK‰?½dàvÓÄozÉÄí…ru›Þ¥Äère—=ê\MãX›Š\¥ûQ¦Z9Iu†=éòꕞJÑ#–¥BŒ’õÅkžuZ¥ dëÍmž}Z†\ò kxÄòql‡hzYÖµ‰¿ãÎI1 á†~îGsõè íF*¿Õi]|OEþ!ä9SÏ1Êœ¿… J{ê¯ðÝZÎ^«Kµ{Xõçd†%Ž5T@UU @¥|âNNïsöiÊ`©ÓIEh’Ñ$¶Iv9ûéÀRs]t¡vx†!F-œ`°Õ|Aªiú&‡¦Ýê:Ö£q¥žŸc O=Üò0HãŠ5ÙˆUU’@5ìááÑšg›§&ô?¶…^ÿ…eð¿á¿ÃoíOí/øDô ?CþÑò<¶}–Þ8<ß/slÝåîÛ¹±œdã5í%ecó9ËžN]ÙüuxÃÂð«¾'|Bøsý«ý¢|'¯_èÚ>G‘ö¿²ÜI›åîm›¼½Ûw63Œœf¾gJÒhýÃ…±×¡ ÷Hõoøâh•¤üs^Ucõ\ÔÒhö­Vèø“F»ÓD±nšÝ‘<îT>>Bx8Ã`çcŠxGÕ14ë]Ú-7míÕ|Ö„ñFQþ°d˜Ì­(¹U§8ÇŸáRiòIèíË+I4›M]j‘å~ÔäŠêK+¡²ê  £Ü×SƒÈã¨5û^ ðH;¦“^Œÿ0x“%¯•âk`ñ1å©NRŒ–ŽÒ‹i««§f­tÚ}ïÚ¢*³u¯f”ì~mŽÃójLÓîÇÈwq]‘óxŠ'§^šê„Dë-®ƒƒ[¦yU)›Ö×9­S8jS6aºéÍh¤qΑ§×NjÓ9¥L¾—@ÍUÌ]2atz|Ä{1ßh^¹£˜9ÚèzÑÌ5L¬÷C֦抙R[°3ÍKf±¤Ù™5ç^j\Ž˜Q2'½Æ~nk7#ª æû¯ÍY¹ÔèíÞ¡×æ¬e3Ñ¥‡9‹­CÕŒ¦zT¨¥ö§ŒüÕ„¦z”pÇ}©çpÝ\ò™ìPÃ…ö¥Ôn®yLõ¨aŽJóP$Ÿ›šÂS=j8{ÕÍá9¬\F•!ã5 ÜëQåF…¥„—;NÏçU\­uOÔôxZK‰Œ}}«²•Ùó™†ii«ŸExSÂh²Dž_5ëP ~}šf­¦î{ö GA³§µz”é$|/)_SÓí,¢X"1·µuÆ*ÇÏT©'&îk¢Œ`(l!/\×4? éw:߈õ›+E¶Ûç_êW m;˜"î‘ÈUË2¨Éä:šÎ­zt êU’ŒWVì¾öw`2Ì^kˆŽFUjÊö„"å'dÛ´b›vI·e¢MŸž_?à¡Ò¼Ý+àÞ„uëî?â{­E-½’ÿ«o’–ir ¨wv²‚<Å5ñŸÑ£x`cÎÿ™ÝG¦ËFú¯³gÝÔ\ ô\Ìó.\O×ú½?ùõMÆU_ĵŸ½N¨ÉYUæ‹iòHüÂñ_‹<]ñ[ŸÄ~6ñ ö³­K¸}¦úRþRgòã_»aÈ¢î8¿6Æcëãj:¸‰¹KÏï²ì¼–‹¡ý¯Ã|#•pÆ8 £ 4•´ŠµÚJ<Ò{ÊME'97)Y]¶cGn8®3ë)áR.¤¬œÎÚx{Ò*ÍÈí…L±{T9Æ‘2ÇíRämD¢:–Í•1â:W4TLjés©ŽÙJåû1vQpöc¶{R¹J³Ûô¢áìÄÙíEÃ6ý(¸¹ÙíNä¸ ()܇L‰¢ªR2•"³ÅíV¤rΉw@×üKàÝnÏÄÞñ§¡x’ÏÙµ]î[;›}èÈû%Œ†]Èì§Ä ­éÕqwLòqx uàã8¦ŸF®éö ý¼ôßÚMµøcñ:ê×Oøé§ÀJHa‡ÅPƹiàQ…K•PZX@2Æ6y‰»…Å*Ë–[þgåYæG<¶n­%zoÿ%ò~]ŸÉëfÿL+°ùР€ ðOÚkà†›ûB|ñ—Ã[¤¶M^êµh××!@±Ô¢Ë[Éæähжc‘‘w˜e•WªéÏÙÉHåÆa–.Œ©½úzôÿƒä"ÐNaaéëé^²v>pSGi§kò¡BÎw/FÏZè…V€‹½‘ìþñÉ„¬flããšô(âz!˜ä·|öØúÓÁþ=_.Þ9fÌk‚#ŒúŸZ룻õ>{1«h{=¢º™õ7…~#Hã,J¸â½jÏÏ3\ZI£Ò–ú@yÑdjö)«Düç%:®Á°Ö·8ùÇ,5.Z\ºtÜ¥dÌÛÏöU×5[sö…ðq‚KkM:&ñ”âK™Z&H…ÌAC©U€¯˜–¨–ÅòÅ›žñFTêÔ–:e̵¾š]oÓ}¬•õÔþÃðÄ x %ÌSMÎ^Æ~êŠR¼œ%ð»¹ß‘ûîR©Éî¥þGG& |#‰ýaN¥™£˜ÆkDô©U±}#"±hôiÎêå¤z†Ž¸T±a_5 1É•ª7Œ‹ õ 1™(oCScU2Eni4i«Ô4tÆdÁêZ7ŒÉCÔ´j¦XW¨hé„Ë õ ™2½KFñ¨L¯PѼj«ûÔØÞ3,‰p)4h¦H²ûÔØÙL”IîE+¤H%>´¬Rá-+˜S/h°œˆLÓ±d,þ¦šFr™UäÏÒ©# Ì¥#õ­R8ªÔ&дoÆ>$ðÿ„<5göÏë·Ðiš}§˜‘}¢æi8“{«¹ÝFX€3’@溨Ós’ŠÝžaŒ†”ªÔvŒSoÑjÏë/öUýŸ4_Ù§à߇þiçÍ×fƧâ Õ¹{ˆï5Y"'x‹*m„yI`"‘©`\»7ÕaèªÔÏÔü8̧šâ刖ÛEvÝ»ëÕë»ÓKGVç–P@P@P@P@P@P@P@P@PæíûTê~&ÔfðÁÍrâÏA³”hx«L™¢–þU9ò­%R Âù¥S™Ÿ/&_¦Êò‹þ÷½ý|üºzíøoxˆâÞ)©dŸ½R.͵Ò-mò_ËÝÖ_騡€WÖS¥cùûsmÜï-4ÜÇÓ\MÎ’ÖÀ q[F'V¹» ¦1Åj¢pΩ«žqÇj',êšqÚÔU¨œò¨^ŽÛÑj”LeP´¶øÅ;¹“,Ò™.D¢j æÉö 9‡}qNÁÌ/’(°¹˜†úQaó1¿g”X9†5¸ô¢ÁÎ@ÖÞÔ¬Z¨BÖ¸ŠV-U)Ém׊—XÔ)IkíRѬjeµëòÔ´m†\Öx¨q:aTËšÓ=ªN¨U1ç±àñY¸p®`ÜØõâ²”NúuŽvêÃ9ùk)Dô)W9‹Í79ÂÖ2éQÄœö›×å®y@õhâ>ûLûß-sʯCq—ú^w|µÏ(Å IÅßé_{å®y@öhbŽQÑÁÝòW4éžÞn§ Ð^isyöŽTŽqØÖpwG¬§OZˆ÷‡ÿ¯4´O»œˆÔàG'AÓ;Oô÷–%ºÔã¯uúŸ{ü/øµ§Ü[ÛÛMp]0Y"¾— ŽŒÕ™øp½zJjÌú»J–-]{yCÆGcüëÑ•EÝC Rµ^Y­ŽÇû+}¾6óŠáúŤ}Oö?= X§ŒØ/&vŠÖXžˆâ£‘É®j›î-—pE^*á7k³›„\ÊGãO‡>ø‡¡ÜxoÆþ±ÖtYw³ßDÊrŒždM÷£+¸!W]ÇVXš41”Ý,D£ç÷]v~kTvd¹ŽiÃx¸ã²œD¨ÕVÖ.×I©rÉm(¶“q’q•µLüåøŸÿÛ±¹¹Ôu_„^7þÎaáðÿˆ£y GiIe[´Ì‰ÆÀ*´R¹)ó9Ý•øìwS¨Üðu9»-VýÖ¶Kmîõ?¤øWé/ÁBž‰0žÖÚ:´šŒšQѺnÑrrW“S§Ÿ»ËgùÛñàÏů„coˆÞ¿Ò-.vˆ¯‰ŽæÕÝ·íí³Ä$"'>YmûFì`‚~+“âòûú–1w/ÇuïXÊ™èSÅ––äzÖn\qE…¸µL1(›íÖ§ßëyãÖŽA{q À÷§Ê'^åy%÷«Q9jV)I(æµQ8jVH¡4ÀgšÖ1<êÕÑŸ Z¥ÒÚZ&é©<É=…m)„9ç±çPÃâ3lBÃa•äþ亶ú%ÿ]´SÒ´Û]×ȃ摹’b9ÿ@;ß™¯^x™óKn‹±úÞQ•aòL?±£¬ŸÅ.²¢]O6ÛrÏ/š˜DèÄVº9BRA®ê1>S2­ucë¿ø'ÃOøYÿ¶/Ã%ºÑ?´´ ý£Å‡úO‘öO²¡û$ü:³í¿’Çä]ÙÏÌ¥×µ……ÝÏÌóüE©¸§¿õùÖ…z'ÆŸË·ü¯…ÿlë:…Ŭ–ž.Ò´½fÅ-Ý™â-ÖÀ¬ ¨üÛ ˜,62ä•_1…§~ç霈æÃ¨+kõýO‘tÖ%Lz×Í׉ûVUVÉDøRõ&1,˜#Šâhúzu.t>:ðGÚ,WÆš†;>&}B&;Mļãt`‚2Ë‘œª©ú¾Î~©Ua+7É&¹|›éèÿÓVÏÀ|tðÙq\A–Â*½·UlêB)>kÞÎTâžêòŽœÍÂxþ×ácÃÀzõ¯ÕiT¹üÁ:mè{¨ePâ½ s>C‡³g¡X^Ÿ—šëŒ½vV7‡š·Œ½¨¶º ku#Ì©JÆÄ3ž9­9'V+Œw«Lå•2ÒÜûÕ\ÉÓ&>ôùˆtÇ¡Ž´s R k¿z\ŪEi/05<Ʊ¢gÍ{ïRätB‰•=ðçæ¬ÜŽ˜P1./úüÕ›‘ÛNÏÝjÏÍYJG},9ËÞjCŸš±”ÏNŽåoµ>ÍXJg©G rÚŸ_š¹å3ס†9ÍK®°”ÏZŽå/5 çæ¬%3Ô£‡9Ë‹ÂIæ²r=tlgiFçBJ&æ—¥Iu"§osZBLâÄâ£IÉ xXÌÑ/åÕèR¡sãñùŸ"zž÷áß ¬*‡Ëçé^¥*>0ÍÛÔöoh"7ÞS•èR¥cä1øÞekžŸcb¨+Àè+²1±ó•j¹3\.8íLÊÇ¿´?í· |/¾Õ|ðêÆ â Œ±Åsst¥ôÛÜ|Øœ£«Ë2… Qpª_æ}Ñ´Gã³Þ,£—JT0ËžªÞÿ îÛ]–×ÕÝ4JxWô~Ì8Æ,Û;“Ãàf›ŠŽ•¦¬¹e(¸Æ»jR»’Žåœj–Ÿ~1üWø·öEø‡ã[íZÖÛiŠËÛ[+®üIöx•#2bWa]ûN3€~k˜gXÌÆËQÉ.›.ºÙY_W­®lð‡†|7ÁœÒÉ0Q¥9^òÖSiòÞ<órŸ/ºŸ"—-Õí{³Ïâ¶ÇA^Dª£ÑÂ[¡~81ŠÂS=XrâÁíY¹° XXjŽ˜Ð,,UGLh“‡¥O1²¤H#ö©¹ª¦H#¥Ìj©òé\¥HxÚ•ËTÇyt¹Šöa²Ž`öbù~Ô\~Ì6{QptÄÙíEÅÈ=¨¸r ÙíNäû1¦:w%Ó#1ÓLÎTÈZ:¤Ì%L­$U¢‘ËR‰Þ§¢êZvµ¢êZ~³§ÏÕ¥ýŒÍ Ö³FÁÒHäRX  €G5½:Ž.èòqx8Õ‹Œ•Ó?£ïø'çíÍkñçF‡áWÅþ/ÅÚ'Šòê;{xüOm½åÝn¤h“Cð…ÜcˆJ¥ÿ|"÷ð˜¥YrÉûß™ù6‘Ë.Ÿµ¥Ý?]=oÑ÷ï§kþž×aóA@üôþßß±Šþk¿?hß k6Ú¯Ã[Už©iw(ŽûJº½¸o3 ´$¶þ|±ª•>`óÕJ0¦=ô+)%¹ò¹¦[:R–".ñnﺻü¯óüÏÊøÙÓ$Etž ’fŦ¡$,¬¬qééZFV9*áÔôgÑÿ>!éP×nÖ(¢ÀÞAfÆ@áFIê: õð˜¸E~ñŸñâ+NøHݾ>÷¢>ÉøYñÂ&†'µ¿6—!•>Ǩ/‘)f$(\®N3òÆFpN+è0Xª5–ŽÏ³Óúùñ>E˜å’j¤9£«æ¼¬•Ýú«y-®•Ϫ4›ÀFÕ8t¯fú™â)¸¾c©…·®óÐô¦û" ¬®ËQ0¬>öj$´±ÑFII5¹ÔɧéúÞ—y¤êÖ6÷º]ì/osewËÄN¥]ÊÊH*F$ò«Æ2¼d®™úU^¥' Ôdã8´ÓM¦šÕ4Ö©§ªkT0ß´GÁÍGàOÅÏ|=ºK†Òí¦ûN“yp›Ý>L´o1 v ˜äd]‚XåQµùNa„xD¨½ºy®½Ïïîâ(qFMC1”Ú´Òû3ZIZòi7ïE7~G÷o´!!DD@+ë©Ó±üïŠÅ¹¶Û;Ë+@>^k¦0±áÖ®Û:;kL‘Dz‰çT«cz PæµQ8gVæ¬6Ý8«Hæ•CR+~œU¨œÒ¨^KQT‘“™qbQÚªÆwl~Õô£@AJã°¸4‡`Á ,.Ú”M¦€°`Ð+¥a)Ü,&;“b7˜Ñ]£ ÔR.ö+<Ò•‹S*In1Ò“‰¬jÒÛ{T4o†\ÖÞÕ ¨eÏmÁâ¡£ª K‹\çŠÍÄí§VÆÍŸ^+'¶cêǯ”¢wÒ®r×¶~ZÆQ=J5ÎNóOëòþ•„ z´kùœöšï–¹åÕ¡ˆ8Ûý3;¾Zç”b†$âïôϼvñ\òìÐÄœV¡¥Ÿ—ŠæœgŠ8]CJ –^‚+šp=Ì>*êÌß𧎵 ÝÄ­+4 õ'¥kC:,àÍ2L>eM´¬ÏÐσ_"(ïw|‘Co›+ÊáV4,ÌOGsÐWÓa1Ñ­³ðìÿ…+师ÕÃÁ¶Ý¬–ï¢^o¢?A|ñ7Ã^-Ó,o4››{ûió¶îÎe’&Á*pËpAÁ¥MÏß§+®ëR¨âá‡VÅRp¨·RM5uutÕõZúíË@êV6zS‚’z“Š•ÆÐv0<çÄsÐ×g?»¡óŸVN¯¼,–¸ŠJ¡U0œ½ ùmÏ8šÞ3<ºØgÑšÓ¢™Å<;zXùâì+û?xöYo`ðÍÏ…õ9eIdºðœâÍYV=žX·e{tSò±Ù±eÎî[w‹áÌ·ïÉÈÿ»§–Ú¯¹~§ëœ=ãGðô?¬¬Di*ËŸVï~tãQµª\Ói'ki|+ñ?þ ×ñ/Ã×ZÿÂívÃÄÚ"áíôÍBQc¨üÒ•‚߸“de¤2E»ˆÁÚæqÜ^ Ë %8ôOIo·geÖêúè~ã¿Il§t8†„°õvs‚s¥¤oÍeûÈóJéAF§/»y½ZøoÆñ‡Ã½v xç×ú&·ãökøŠy¨“̉¾ì±–ÂÈ…‘¶œ_#ŠÀWÁÔt«ÁÆ^u×uæ´?¢2,Ë8 vUˆjNÚÅÞͤùd·Œ’jñ’RWÕ#žKÁë\Ž™ôPƮ夻½fépÆ&;í>ô½™[CMÐíOÙñdOsÇZ¥*˜¤ÑŸ%É,±Æ HÄU$û Ú4ô»Øój✤¡y=[·ämYxfòíkéͺ6”«—Çpºq^¼ŽÕËW mÆš¿ŸOø?îà8WŒŒjã*{4ìùmy[­úEÛo‹}RjÇcaag¦DÑZG·v7¹9g u'útä×™Z´ëÊógÛåÙv)¦éá£kÚíêÝ–íþŠÉ6ì•Éä—æ¦17«ZÆtÓpkhÄókWÑœ¶£pcšô(@ùÏ’zŸÑ§ü[öp?~ê?|Q¥y^4ø‰ìïµA¶k-&>VÝñ,‰ö™Nv»Ç,IfãW·B±¹ùni‰öõœVËóþ¿Sõ¶·<Ãð{þ -à{{}sàOÄÛ/Ý«»mCBÔõÄ4 ‘43Ù[¹Ï–ŽLú‹¯Ü >ðŒmó³^)ŸcÂŽJÓ¦ßf~=i7dl¯š¯öü¯{éàýCç-éÍyòG×Ò©sê¯ jÐùi6sŽõŒ‘éR’±áþ>ÐáðWŒam2àÐuxÍŤQaVX”n'•qÀP$Ú¿PálÖXÜ?³¨ï8hÛêº?Ó«ÒïsøCÇ®¥ÃYÂÆ`©¨a±)Ê1JÊ2VSŠWm+µ-£Ρhf‹«+ÆŒõ†¾ÞKŸËØÌ+‹iž¤jA©jí§3æqx{jw–—{@æºc#ëJçIk{ÓšÚ2<ê´’Úô`dÖÊGR‰©Ø8ÃU©²¤[[Ÿz«™:dŸk´sì®1®ýèæ¤@÷y¥Ìh¨”e½ëÍC‘´h™“ßuæ¥Èé…ãP9jÉÈì§@çîµ03Íe)ž…,1Ë^ꇟš±”ÏNŽåo5?½óV™êQÃ¥ö©Áù« LõhaNFóR'?5sÊg­Gc—ºÔ3œ5c)ž,9ÎÜ^–$ϯ¥däz¢‘ 1Épà('4’l¹ÉSZn•¡Mq"„ý+xSlòqXèÓ[žãáŸ9XËEøb½*8sâ³,Ý]Ùžýá¿ ª*/ßêQ |cš7}O]Ót@»p+¾Ï”Äc/¹ßÙØ¤(¼ éŒl¥W6|Ýñ‡ö¼øEðíÚRê_ð’xÎ ñÿaèn²y¯˜»ngÿW$‹c®ZTÜ”E|þiÄØ²ðr稾Ìz=w{-UšÕ®ÇìàwqÇ³ÄÆÕ°’³öµSW‹åw§ŠwŒ¹¡+Fœ¬×´Lü½ø½ûZ|_ø¾o´·Õ?áðdûãþÂÐÝ£óâo5vÜÏþ²lÇ.Ç\¬O´)M~sšñV71¼¹)¿³«]ÞïGg²}íð…ø-ÓÄÊ—Öqq³öµR|²\®ôáðÂÒ4%ïTÚö7Aj8¯••C÷ªDºqÁÇJÂS=jxrÚCíY9 [H½«7#²K+LÔ9Q¤L±ûT¶odÊ•-›F™(Oj››( J娩¹¢€ý”®_ »€í¿ZW+6ýh¸rß­@ÛíEÇÈ&ÑNä¸ °QqrˆR8+N丌)Nä8²U&e(²{U&c*w*¼`ÖŠGJIÙÝêZ.¥§ëZ.¡u§ë:|ñÝZ_ØÌÐÍkxíZXÜ1$ ÙáuB%SêáprTÜæ·ý?àþGÀgÜIF¦2l<Ún×’Ñ|£ëñ5£Lü|’9"vGR%N£ÔU5c(ÉI]lĉdy8T³9ªŒ’hZìj)¹t>…ð‚<ˆã¾¾ù®ŸƒŸ­z¸\5—4·>=ιäéRøWâ}¢h10DµzÔé-ϱ¸é+»Bx*÷HKË¿ 꺆‘%æÓ9Ó.¤µ3’7#8,ݼ}ko«JÝ6ã~Îß‘æ<ê–)Æž2œj¨mÏ+_·2vÙ}Èܰø£ñw¾\GY‡W²†vúµ²É·pæDÙ#¾g9ÜIÉäTqXª?jëÍÃ?ĶAæi¿déÉ»· 5ßK>h¥®Ê*ÖIYh} ð£ã¿Žn?±õ«ôÏÆ„K!h¯@Q½¢Ï*A |²I ‚°Å},.9bW$Õ¥ùú—æ|f{ÂóÉ&±8yûJ ïmc®Š]Õ¬¹•“zY]_é+}@E´!äSm̰ٗ²²‹/kö>ñ‡o4è:~¯£ÜlûF™ªÛGsÛX:ï‰ÁVÃ*°Èà¨=EyÕ0Š£äšR‹ïª>Ï ÄRÂSXœ5IR­±n2WVÑ«5tÚ~NÇå§ÇÏø'Ï€µMûXøgq¢ø®Ê%0è77òOg©….YD“³[ß÷rµEd›Ö?½ðêy”sטà}Å9{¨>xRxRúRXŸ^º`\YÅ8QB´ì­æªK¨S(–?WƒöÏš_ üOâž#ytÅ—þJ»Û¿n›ßk?é¯KÒôÍLÓ´]NµÓô}>ím,,¡Xaµ…*Gj¢*€¡@¯}$•‘ùç*’s›»z¶ú—©’P@P@P@P@P@P@P@P@ðGí5ûNɣͨü/ø_¨ÿÅB A¬köÍÿ ÎÍonÃþ^:‡qþ«•¼É‹è2œ§ÛµZ²÷z.þoËóôßò|@Ydg–e“ýîÓšûãüÝßÙÙ{ßÀúF’‘"*®WÚB?™1x§6ÛgwcfZêŒOµ[Mµ®â¶Q<º•MØ-ú+TŽ)Ô6!¶; LŒ1‘Þ`W†Ý äƒ¸c²ŸЧ'í«9/$£ø·/Ëæ|Ö7é?šâé%–å°¥;êêT•Ek=cM;Û^f¬šåwºå¼_û|?Ñæ±¹Ó¼]âÓ£ó>×otÐK$Ù'—"Æ¢<“”}÷­e_…0”Úpœ­Öö»ígeo¹ßÈïÊ~ÿ‚|?ÿeOÉoö][À¤øÎÓÌ—ËŠo±Á7Ú#“¹lÚKu±FÜÊ"ÜÊ»³x{Jm–S‰x\\'ßO¼þZ´¹ËÍ|ÅxŸ¹å5ž‡©xzýáeÃqõ¯.jÌûÌ-Nh£èO k¸1‚ØöÍsHö)#×õM.xWPÐL‰ ÉæÙ\>‘p¼£nÚÄ)?+`d£0k³+ÆË/ÅB¼v[ù®½½Uô½ã®£Æ#*ª—4•àݽÙÇX»ÚM+û²q\ÜŽIn|çp5¿ëóxsÄ–ÿfÕ"†ÒLW1»,L~ò6¸ ‚×rìÊ–6’«IèÿÙùÿ[j|gÁ9‡ ãªeøøZQÕ5¬e´¢ô¼]·²Öé¥$â½SEÖUÑ%Gü3^í:—Ôü«ƒqn-§k;‚†l×\*;ˆÁÛc±´ÔCWDfyh4oÁ¨ôù«U3‚xs^G§ÍZ)œ³Ãš ©`}ê®sáɤOñSç'êÂ@Թưì§.¦9ù©9šÇ fË©ïT90Ã:§æ¬ÜκxSºÕ:üÕ”¦z°§9wªg?5c)ž,1Ë^j€gæ¬%3Ó£…¹Ê^j¹ÏÍXÊg«G rךŸ_š°”ÏNŽåîõIù¹¬e3Ó¥‡±%ËIœ;šÍÊçdi¨“ÙØÍvã vÓŒ\ˆ­^4‘éú†$}„ÇŒ÷ÅvR¢|Î;3Júžóáo!ØÍ«Ô¡‡>3Ϊç¹éTT?Ò½*tl|N/1rnìôý/IXcEÛ]°…šÄâœäÙ£â Þðî«âÏj°ižÓ"3\Þ\¶5È2Y™ˆUE™˜*‚HׯK JU«K–1Ý¿ëî[·¢#+ÊñüC¥–e”Zõ]£îÞþ‰%w)6£§)4“gåGíûnë¾57¾ ø?5öƒá¨nþÛÜ<º¤i´¯”V¶Œ¸by2:„ËHÛólûŒ'‰¾Ü ŸÅ{9[·X«üÚ¶Ú£ûk£–%p͸®1ÄW”t â¥N›w¿5ÛY(ÙmÉ s5ÎÔ*/à¶+à%3úæ†#N+~œV™êR×ã‹bäz4èØº‘{VNG}:E•Ž¡Èê…"§µCgLi“ªT\è2PžÕ-šªd‚:W52P•75Pú~t®Z ŒÒ¹j#Ät®_ á áµ€ygÒ•ÇÊYôý)Ü\¢yxíúQpåP..Q¦:.O(Ó¦'…OqNä¸ +Nä8‘•¦C‰-4Ìe»%Zg<àT’.µ¤dqU¤jø;Æ>.ømâÝ Ç~×®´_hÓ‹›-JÌ€ñ> ‚ º2–FF•ƒ+z¨Õtä¥Ñàæ8 xªR¥U^,þ¯?dïÚgÂ_´ïÂÝ+Å:V¡j¾7Ó ‚ÛÅQ˜L¿)ó‰ÛìÒ2ÈоæÜ€©>bH‰ô´+F¼9–ýOÅ3\¶®Wˆt¦½ß²û¯óïþV;OŽ?¾þÏþ±×üo=ä÷Z„âßOÑ4ˆÒkíA_0ź.ÈÕƒ;»*®Us½Ñ[² â%Ë|ægšárŠ>Û+.‹«ôGã¿Å‹?j-KL—ÆÛi~Ó'’{ ifCLÌûeØæ{…‰„~fp¤qùŽë2ì¡RÕêÏç®3ñ¦9û8>X-’üßwø.›»ùo‰¾¶––aPdíUÀ9'ñë^­l&–Hø<·ˆo?iRZž©ü"HÒýœ—õ#­y“Àk{q†âÅËËÍ¡äv-½¿Š5 Xhíe0çieáÇ>¸zq\¦•V—Cë+ã'S “ÞJÿ'·Þ¬Ï¨ü+`A‡Ò½ªÐüÇ4®Ô›G¹hV#÷ixÍzt£Øøœu}Ü™ëÖz*Él”;×tiÝ'[ã;¦sÚ¯‚–ã>HÆzƒYO }C :Æ^ü9‰£t–0ÊÃÁÏ,"êzôx†I§cÛ~|U³ðÌÐøgâu÷”¹X¬OùVÏmKèÔt­^ÚKCÔíoôÛÂ;»–h¤ÚÅN×RAÃ]˜Yª‘¿Cç3Ü4°µ}›M7ºṲ̂ÈEv&|ì Ñ)5I˜J Ÿ˜?´ßìg¬D¾/ø¢Ag®ù¤ßøU./’e¶iX$,…¹‹+E2m“âs¾Uí²øÚ]c}ú«è­ÛEm¬ÕŸõ…Þ=×ÀOû3Œk9Ñ·¹_•ÊPåV娢œ¦¥m'iTçoÉKšŸäþ³£k¾Õ.t?h×úN·m·Î°ÔížÚxw(u߀˕ea‘È ÷¯ÏkP©Fn"ã%Ñ«?¹ŸØ9nk„ÌðñÅ`«F­)^Ó„”¢ìÚv”[NÍ4ì÷M£ŸÞ¹åÚ§ˆ-¤À÷¬ÜNÈWL°²ã½C‰Ó¶,¬ Ô8Qª™(z›*„Ë%C‰´j“,žõ.&ñ¨J$©±ª¨J²T´m „ë'½C‰Ñ¤ë%K‰Ñ¤ÂOz—xÕ%Yj\M£T˜IïQÊlª’ =éXÑU$Rå4UCÌ¥Ê?h!Óå%Õ#i±Þš‰œ«X©$ãžkXÀ㩈>ÁýŽc¿~Õ¾/’ižëFøE¢Î©®x•n‘ðìv{W¹e*KV`î h£—ÑÂ`Ýgw¤O‹â$§–Ã’õW²íæü¿?½¯ê+ÀÞðÃOè>ð&ƒk£xKF€[ÙiÖ€ì‰2I$’Yݘ³»±.îÌÌY˜“ïÆ* F+Cò:õêbjJ­Y^OvuuFA@P@P@P@P@P@P@P@P@*þÓßn¾i‡|(ËãÝv9 ¤hÝt¨ n"IfbHˆ2ì,ŽX‘Gõr¼»ë³æŸÀ¿/óÿƒsà8÷ŒÕŒ*¥‡³ÄTNÛ>U·3]{FêͦÝùy_厉¢¤ÄŠœÕ÷ÔéÙÉÜc¨Ûlôk  dW\b|õz÷:›[QÀŠÚ1<ºµN‚ÞÛÅj‘Á:†ÌàcŠÑ#–s5c‡ªìsJEÅ@VÄn<J‘Øx¤?o­+š(Ž íJå(’©¹¢€í”\®AÛ)\¥v{R¹^ÌMžÔî.@ÙíEÅÈ4¥;’à0¥!ÀaJ«â4©§rF‘ëL–†•ô ††‘ëNâhc 4÷'b¬©íI¢Ô™Ÿ5¿µCFð™—5¾sÅCGDfdÏo׊†Ž¨T1nmÎEg$vS¨s÷6¹Ï“‰ßN©ÏÝZx¬œNúuNfòÈüµŒ¢ztkå_–°”ORs“½ÓÁå®y@õhâ2ûOûß-sʱCq—úwÞùkžP=šƒŒ¿ÓAÎ¹åØ¡ˆ8mKK åúŠæœoŠ·SžÓnåðî«gw%¹»Óâ®´öm©xˆáŒmG Î kͯ‚¡^­*µ ›§%(¾ªÍièíªÙú¤z5©CFP¿,ìÒ—X¶­u³óÝl}à{[=^ëJÑm¼Uƒã»ÉØ(W—Mñ$NdÛ-«¾LŒêc11P|µ@û¢Û¥?yG›•¿¹ù®Þ6µô_)˜a›£R«¢êÓŠwM¥R›V¼e¿2KU-\“ærq´åéü_ø›ðçQÃþ+Š}&á·å ¹.ù`0ÈȯEc±YrUÓõ>2§ åå)b0-NÛ­œ_f¿ ê™ôg‡~4é¾$³´’÷U·†ý0%:ÄöeÉÁÏ|wÏb½âá]+½OŒ¯ÃøŒª¤”i·–MüŸõ·Ìú/ž+Óç‡0êJÅ圿‘®ú¢úŸ'šã«Ó|¼z¦Ž‰üOj%9|Ÿ­o'«M8Ö­.v_·ñ%­ÃÁõÍdšlï”jBñnY•Æå`EtÁ."¥ŠÍ6­iËÔäu[VDp N×&NÊÆåÞÉYAéS'©¥8Þ70¯uŽ6¹5.VFÔè¹ÈómgT@—À×%IŸCƒÃ7m•þ%øÆa¹_0l÷¯ˆI3õÊ%9EÛSó«ÄÞ!mkU¸¹˜A!9í_”gx¿®â=×xÇoÕþŸ+õ?Ð/ 8wýWÉïZ<µ«YÉ=Jê1jíiw-“\Ü­{§=öŸzñý™ú3ÅùŒk¬÷¦©‘,UÖæuÅèPy­áJ癉Ç(­Ï¥þ~Åÿ´Wí3ä_øÁÿ`ð\»¿â±ñ+=Ž˜qç/î¤ÚÒ\~ò‰¾Ï¾[•l5ßG Þ§ÉæÜ)Þ7»ìOß²ïìÝàÿÙcá>ŸðÇÂW×ZŒ¯pÚ–¯¬Þ¯ªj$i$Â-ÅaM±F‰“µ#]Ìï¾Gô¡d|V#,MGRGÑ5F@5]+K×t½KC×4Û]GEÔmä´¼Óï¡YໂE)$RÆÀ«£)*ÊÀ‚ b¦Óº?ˆíSA×<â-Áž'²û‰´ û/Q³óR_³ÝA#E*oBÈÛ]eISŒ‚G5ó˜šv“Lý—$Æ*”a(¾‡S£\á”æ¼zѳ?IËksDõ]#V´XnZâ’>–M¡<®ï–!æzVks­ëÿ©øsÂtTÑüIiÌ#e‚ñEÅ“6Ó¾%U ìÛ@`à ú,u|ERŒ­åÑú®¿ÕâŽʸŸ ,cINé¥+.x^ÚÂVn.é_£µ¤šº>RñǼKðŽ÷NKû¿í^á-µ˜¡1#ËŒ´R&[Ë~ $2ŒƒÊ¿§dùå<Â6øf·_ªïú?•ÿ†h‹£´fâcòD¤ªd|Ò•FÊA¯6â<Qzs|Õ?•y­.ö_‹³NͨøàÇøŠ¡ŒÃEPÁ6×¶žÎÒJ^Î Þ›Wv~í7(ʤd¬~=|]øÉãÏŽ~"µñîà g“e¥éèñZX©y‰˜îvPÌÌÌÇ 3µQWòœÛ:ÄæõULCÛd¶^‹]ú½þI%þ€ø}áŽKáæX,¦ ¹»Î¤ìêMëni%h§hÅ%«·4¥)y¼6Àv¯S?P¡…±§Ž+žS=Z8ròB+'#ЧAÒ/jÍÈì…+’:ÍÈë…"qC‘ÑDÊžÕ-›Æ™:¥Kfñ OASsUUÖ“fŠâ?ASsEÂ?j.R*ÇíšW-@—ËúR¹|‚ˆÏ­AÂ,ö&•ÊQ±¢áÊ'—õ¢âå/ëEÔŒÇíšw%ÄiAéNâåc —…=©Ü—2”îC‰OJd8‘§s7&J¤Ìe»¥Zg4é”e‹¯¬dyõ¨ž·ðãï¿f_ˆcâOÃÄÓgÔä±›L»°ÕíÌÖ÷¶²síeuÄ‘E du;£’¥‘½ &%К}:Ÿ#Ä,s<4©^ÒÞ/{>««®êêëªvkëßÞüPÖo¾"kúÌšö½¯Ëö«½^à†{‡À\` P‹ ±ªUP¡Gë¹e:5)Ft,âöþ¿3üêãŒng„ÇÖÃfœÑ¯iEôíkif¬âÖY¦ÓGÕ^Ñb‚(ÂÄ c ôÔ)¤Ä3LdªIÝçöµè)$jôlWO³R –6œj+5ï+µ}ì÷OÍYùŸOø âM—‹-mìµ9-ì|T§Ë–Ç~Ñ;,^NYHV%y+‚F½,>"5U¥¤»—õ¡ñ™¾QWQÔ£yQz©véivwv¾Š]5º^±{…k)Xà¥K™0c'RS)áûœŽ~øâUˆÓ¼wàÝ'\·H¦‚Ô-RImVPC¸ß «óÆÊÀªAPFœ&\D·Ým}ì÷^ªÇ«’ñsÃu½¶OŠ7ù$Ò“‹¼yãðÍ+¿viÆÍ¦¬Ùù÷ãÿø&f‡ª_êš—Ã/O¢Ûɲ[hzÍ©¼‰n vHÅÒº¼p`Æ™d–E X™ Å|Ž7„(ÊRž§*èš¾¾·º[-S~§ôO ý"ó*©aóÌ«$Òu)Ë‘òÙ&Ý7Oâ–’§ÚŠPJçÅ?¿b¿ÚCáÔÒ™<sâ=,Mê>Ý©¬ÌÑïȸU\2—x•w dîRß/‹áüvëeÞ:þýéºðÿ‹¼-žÅrâ•Ù·ß»i'o‰¿fÛÑ¥·g{i$¾YK¯S^#¦~£OÑ–’àzÖnd1+¹an:sPàtÇN³ƒÞ¡ÀÞ8‹“¬Õ.'Dk,Æ¥ÄÞ5™2ËPâmÄË/½K‰¼j“¬µ&ñªL²ûÔ¸›Æ©2ËïSÊoÄ¢ZžShÖ${ÔòšªÃÄÞ†—)j¸ýèå\ŒÏŽõ\†rÄX­-ÈPIl ¸Ó¹É[¢®ÙúWû~À^(øï­ØüAø¿¡êšÁ;?&æ{¸å³¹ñnôYcKbpËfÈèÏr¿}X$-¸¼z˜\3橱ð¹ïª1tpŽó}{Áòûüÿ£ß ø[Ã> Ñ,¼3àïiz‡,÷ý›JѬ⳶·Þí#ìŠ0w;³Y‰<“^ÂJ*Èüâ¥IÕ“FÛ}^¬Ý¦@P@P@P@P@P@P@P@P@PŸ|Pø¡|,ð^¯âýrâ`’ÊÊiLM¨Ý•cº¬w9SÈVÚ¡œªÄo†ÃÏUR‡_Áw<œó8Ãä8˜ìCVŠÑ^ÜÒé£Õ¿'evôLü[Ô5-_Æ~'×h¤WŽ3ha$hU£—j(ÎQ|•>øy£·F¥hªøGjѵµÒI}™.«WkìÝÓWgí—Æ/Ùþ×â†n,ü@Ö·š·’%ʶh óI 39@NHRî@ùInIöåÍZ“„×ä~[IPËsâ¨GÙËTíö–êö²muv»ù#óPýžüG¥Ü^ZhºÄwVîÂ8îþdld€H®N9çøkxËàzžž7Šp´dž"š”íoëÙúi~çœøwâæ½á+å´ÔÖx!¹ìj(ãêP•§¡Ó˜p¦5¥í(5$Ϫü=ñ†Ó\·ŠSz†ls†Æ~¢½ªxèÕWlüËÂÕ²ù´£¡éú/Ž`fSö•ÏûºéÖsç±™ueöO\Ñüao0T7sØ05ßN¬{Ÿ%ÀU_dÝ—_¶#™=«gQl0•;›Äö±ýÖ‰©ö±FË/«-Ì ÝvKÊŽ2{Vr¨ž§m,ÒQháuMtß?ë\Óª{X\‘ã^-ñ}½¥¼ÊgÈ=ëϯ]Ea”å3«4ìq¿ÿfßþØž"ñ¿‡tïŸ h:”SÝëÂÅ5 ³Ë&Ømüƒd”¡ˆŽ&½5(SÖÏfú'ùìÓµžŒ£ñ[þ )ûJx.âiþjšÄMÜE opš>¡°ÄYå– —",ŠP¹‘Ûr6Ð øùàŸMOé 7Á«UM~+üÿÍ<5ÿÁýµ5ýrÇIÕ>é~°Ÿ™­k^!°’Ú×j3 ëk,óÅB ‘7ÌÃ8\°•‚—SZœKI+Åßäÿà­ÿvý©?è{ø]ÿƒMOÿ+O©>ç'úÍå‡ùŸ^~ÍðHï xUÑ|mûCøš×Æý…ÂÜÅá-"3ýŠPËÌ‚KÄ ÛÉåì…#£‰ãbôðц¬ò±™Í\EãOEøÿÀ?b4­+KÐt½7CÐôÛ];EÓ­ã´³ÓìaX ´‚5 QF *"¨ ª bºO¶ÝÙ~PóÿTý™.~|Röƒð¶ŸkÃïÜEm©ÇÄm5ï.Fr TC²â( ÆLÈÍ0¹i ïŒ7£uβáŒÁÆ_W“ôþ¿®‡æ>™rFÚùêð?aʱVIîw‚¹5çÎ'Øaê¶z—†õ™meMǯ¥`ÕVæV>🈥-dôïSÌÍ}”[>–ÓàÑ|c¡^xsĶ0ßè·ÑùSÛOœ0ê#•`@!H@5߆¯:U í$|žu–a³\=L*š9«4úÿ“OTÖ©Ù¦šGÄŸ¾x¿àÜ×ÚÂGqªü9I#úòg¶;¤_™XÍ å±tåY¶Òr¬òž.*vŸoòÿ-þëŸÅán3‡êÔÄa£Ï…º´´º»ÑItknk(»«YË‘rú7‹â•ùªèz2œþµô´ë¦~#ŒÊeô³=Ã[ŠE ²ƒíšëDÏž¯‚”]š:5’1óÖª¡çÏäi¦µþÕZ¨sKäOý¹ÇÞ§íHú‘k`ƒó =¡KägÍ­uÃÔ:‡D0~F<úËüõ›¨uûWZ·\½e)Ô°¾G7w¬¢ç “YJ¡èÒÁ¶swzÆCeëT=X?#’½Ö@Î}I¬%Põ¨àÙÏ˪™Xª¶O©8¬\îwÇ Êµ.Øi7ú¤Ê#¶÷±üª£NSf5ñT°±Õê{O…¾O'–òD}OéPÂ6|ngÄQÒgѾøy!]ààtã­zÔ0‰t?<Í3÷==£Kð¤i·1ʽP>7š7Ôï,´X­‚,gé]1¦‘áÖÆJ§R¯ŒO޲¯¬eŠÇÑÖ-èêC[ÒæºJíóAÊéIZðSœ—í‡ôüF§«öêQ?˼uxëíí0Ä‘[(ž\ª³Ë?h¯üø§ý³ìßgÓ›Qó<¿3wÙYnvc#ïy;3ÛvpqƒÃ›RöØ*±½¬¯÷køØúϱÿÙüK«ËÍÍ5 ^ßÄNö{s^Ýmk«Üü–ðuãm‹-_‡‘ýG›ÑWgÔ½À‹æ¯f„̳Z7¹ô&ƒv&MzÔ¤|:•®{‡8b„ž+¾›>KNÉž€³óÎ+¤ñuY¥m«@rô5ňh ²ç5Ÿ:½Ž¸áeÉÍÔó¯øydWeLƒíYÔ§s¯Œ•)rÈðoøEÎé­ÚH.ãa$SÂÅ'S•eaÈ`@ ŽAæÖÃßm϶˳~V”¬ÓѧªiîšêŸT}ð—â%¯Œ,±59Ì^3ÒáQ{ ûݨÂý¦0 Œq¸(¶‘‚¥ª–#rËâ[ÿŸõ±Ž;(xYûz ôfýÛtëÈïwuÓù–»Ý/n†Én@d‘YÙ4:öØqÊÝGipè¹Æò¬eŠ=*9öEÕÒYκ Éâ[WGtrhBQŒ´lٷЇæž,÷0Ù]Zð/†¼S£^h,дígÃ÷[~ѦêÖ±Ý[͵ƒ®øÜl2« Ž ƒÔWjª´\&®ŸG©ô™~¦]Qb0õ9ÇiE¸µugf¬ÕÓkÐøÛâ÷üËömøgª]xÃÇÁ-¸ÃŪø`˜­ÑÖ+Øäy[¶;¬K¹OõŠY‰ò±E ÷j<¯Ëü¶û­ê}îOâ&m”¸Â¥_mMtž¯{¿â¾é99$ŸÂì­ù[ñÇþ ÕñÓáAŸUðd?ð±<$˜ÿHÐ-™5³å/ï,2Îs$ŽÓa#g,q^+$¯GÞ‚ç^[ýßå‘ú¦Câ~S™µO/aS´Ÿº÷Úz-’¿2Ž®ÊçÀ©që^+úd1=ËKp=k7²”º“­Èõ¨p7Ž)|÷©p:#ˆ¹:ÍPâtƱ(ŸÞ¥ÀÚ8‚UŸÞ¥ÀÖ82uœzÔ8Ä.äŸh_Z\†‹ñqïÅ.BÖ&⛕é{;”ñQ]H^ô óеHÂx亟Süý¿h_ÚKÈÔ<á°ø6]ßñXx‘žÇM8ó—÷Rmg¸ýä}%ØåD›ÍtÒÁΦËCÄÇq&¤¥yvZ¿ø;yÐ?ìïÿ÷ýŸ¾/^mþ/ˆö¾Tßð“øž4›ì× ä¾û;_õVûfƒÌðóǽ—Îa^¥-::¥v|ažâóÔ¥ËËõ}|úytWIãP@P@P@P@P@P@P@P@Pãÿíñ¨üiñdÞ¹½_‡zGÉeo7îÖúà xcÀa•`ˆ’ª Âkî2|·ê稽÷ø.ßçúÙË$q§öþ)að’V§²ÙJZÞvßm"ÚZû®RG›é–[UN9¯£„l~3‰¯vv¶VÝ8®ˆÄñ«T:[x:`q[$yµ&o[ÁÓ5¢GI›0Ä+DŽYJå 1M²l<Z’Ò~”›4Q% RÙª‰2­KfÑ…ÉÄu ¦J±Ô¶me…‹ŽjŽˆÑ${Ræ5TGˆ}©9#Ì4¹‹t˜¨æ'؉äûSæ`DÑ{SR1•#W1“¤Fcöªæ2•"Ž©3 S±J«˜¸ª¹” DVªæN#Å;™¸Œ#Ò™ #ÖÈ"‘2)°Ft°“PÑ´gc2hsœŠ†ŽˆÌȞ߯ 0™‹smœñY´vÓ¨`Ü[c ŠÉ£ºCžºµ àu]-Y[äãÒ¹'ÝÂâškSï¿Øëö´Ô4 ­à_ÄÙ®/´;©b°ðÞ´CI-„ŒBEg.2ZJ¬mÖ"BŸÝ`ÃÓÄ8MR–ÏcÆâ¬¢¬%LuïE7%µÒÕµæ·k¯Mwýñ¤HóêmeóI÷ŠÏ½}eE3ù÷6ÅUtÓ[=οŽ?4ÍiµJÊÓËidyqÔ©$ž¿pæÕNqGÔð‡WËå e¢I|ø¥üY¿øWñ¦{ß \j·;´O‰–wNSI¹1˜ÒÛQ·‘Œ-bÎQüÔHŒ¸yDN^“­íð’¼5K¡ý—fqLBå”¶’èüÖÍ}ÏÎÛw>üxýõ-BøNòóÖPApþ.Р¸ºÒ6JÁ5ÑDoæŸ,¤¡vÒWFnš¤eÔñsN«A»ÆëºÛòüÎ'ÂßãšDÅÑ<z×§C0¿Sás>pOÝ=ºÛâŠIó.FÒ;µzKu«>*§ 8ËHŒ¬¤—Ëy'¸è(úä[ܯõr¬c~SLøÒ3qp ã9Í_Ö4ÜæþÆ’•¹O5ñ7Äh-âšI.Q#PO-Šã­‹I]³èòÞ•I(Æ7g¢~Ο²ÏÄoÚž{?^ÝüKï"ãYŸrÝêñ¦ÿ5tèÊ•l:ˆšiEfm¢VŠHÇÎc3-yc«?há¾披[Ýâý?/óµÜß„_¼ðCÀÚ_€<¦]×2Mq1q¨Ü0î.$o•öŒœª(TUUðªT•YsKsõ\&–’£EY/ÇÍùÿ[™Pt…P@P@þÞÿ 5_Œÿ²¯Å xkCµÕ±jÌôc.xØú—Á~(|‘æ~µjlÂt"Ï¥t_DIDZ®ºuÆeÚ½5ø…ðá‡Ä“y«Åh|;âé·ÈuV1<§Ìm×}ɳ$›Ù°²¶Ð<À+ÝÀçxŒ%’wgúvòéä~SÅ>åAÍ9Söu]ýøévîï%´®ÝÛÒNÉs$|â?Ù÷ã7„îo›KÒ"ñ&‡o“¦££ÜF®ñ©l)¶‘„žnÕ ²?0e‚«9¯«Âñª\ï•ùÿžÖóv?Ÿ³ßóÌ IýZ µ4›¼ZNÊúr·Ìåe~X©odÛ<üQ}¢êiåµÖ›ªÁ·Í±Ôa{y¢Ü¡†äpÊG‚ {Ôq°«(I4~S™p¾+VTq4e ­ÓM5uutõWNúô7âñ„EF\}+©bàË(•Ë âÈÛø¿Z~Ý<©¢_øI£ ’ÿ­?l‰þÍi™óøyÚß­C¬tC-}Ly¼L§9˜~u±× µö0ï|Oƒ™sô5”«#ºŽ['²8ÍCÆvÐÿ¬¹DÏL°æ¹jã!Oâ’G¿áÜV.î…)NÛÙ7nײgIðóÃ,ø²×RxZcÒmäògÕµhm¢“ap¹ÁglÈEb»Ð¶ÐÀÖ˜Ï2MÐøWWt¿àü¯m.pqM|/¸SÍ‹%uN²›Wµì¢·³“Š•¤£vš>¾ý›|¢Øêwº÷ÄKíAcPé%œX-º€K7™w cÆsž=yäôa 9Õ~ªÊß7õÜü戹–2­:xL `ÞIÊ£oKZÊëü׺µºùw…¾¥ûG$V’Ÿ•ócØÀFW'Û'¦¼ü Jœc7ÌÒWvµß{-ût>›4âA8ÊJ볺ù;+úÙzTø;á m…¾ÍÇ«ßÃà<Ëó~-Wk˜úHøs Œ*òÄ€¯ZžEj|/ˆ%ZV‹:› Ê,`xVѦy•±«¶vºJD+Ò·Œ,y5qNGÈŸ´íWáÿ‚w+áM {â‘’ͦ)’¬„Ä÷A,Ä”a*Å2Å£ …þg>âJYCö4×=^Ý#¦—ÿätvÖëKþåá7‚¹‡ˆpþÒÆTx|vRµåU©ZQ§}JéÔjQS´TfÔÔÔ‹Q,¤Ô®Z‰a`ö¥rÔK)l}(¹\¥¥³$r)\|¤‚ÌÑqò’ ?AJãåÖ^Ô\9HŸµ)ZJwR»[J.O)[ûS‰]àô§rJÍ;S¹.$-µ2J옧rHŠS!Ä…–šfR‰]’¨ÊQ+ºU¦sÎIÚ´Lã©Lɹ€xâº!3ÇÅPM§±ÇTÕímþ ømÕôÛi%Ñõn2o Vɶ!Ûq’5bP&G“O+/úÿgÿY¦²ÚÿSåwÝ/³«Ýt·Ù[+kþrý)<$–K‹ŸeÀ¯4«ÁGøu²ªœce {îm?m$ù¥í-ÑuLô¯Ðã¸Ç˜.´»mJÎëNÔm!ºÓî¢hg¶¸ŒIѰ*Èêxe AàƒYÍÆIÆJé¸hV¡R5¨ÉÆQi¦škTÓZ¦ž©­Ám.ËQðæµ©xwXƒìú¾™s-Õ¾õ*hÜ£®å%NH8àšüâœeJnœ´kGò?´±u)c°ðÅPw§Q)Eꮤ“NÎÍ]wW>‰ð¥á>W>•ëP‘ùîiGsè¯ÝqÍzÔ¤~{¥¹íZÏÜæ½LøÜu=ÏL„´¡ô"»ó²VgQ§Y´·ZÊ¥Kø<';æ‘ÖÅf8«ŠUlϤ§çކþ–Òqô®˜Vº±ãbréB\Ö8OÃ~p|íÿ¾kNNs‰bìÑó§‹¼¨éúµ¾³¤\Mg«Y1’ÚòÜᑃìA<H<^f' ÛºÜû¼=Чìçgº×Ü{ÂoŠ/ªnÒu¥[}j™¡ÚãþzGž«žÝTðsO57§,·=Œ\"åíè»ÅÿVgÓvúœjƒƒ‘ž £Ì:9’¢µzŠÚ–æ) p4ÕX4D³EW·±Ó[kQ¨œb¸*aYõ˜Lò +±º¦¿ÙÏ–Àø¨¥†jZxìê£x³›·Ö€gâ»æã𤮨é5µpv¶i1Å_;[&p¾/Ðüã­>='ÆÞÑüA¥C0¸ŽÏ\±†ö(æ Ê$T‘X îc8b;šÒXu—-H)/5s’ã2Æëà«Ê”Úµá'm®švºZy#ÂÎãnù4½*:uÚÁ†ÉíÂJœ¨ÎÖ \²< H8ÎŒlû$ŸÞ¬ÿ:)ñ^ ølʳ”oñMÎ:¦µ„ù¢÷ÒéÙÙ«4™ñGŽÿà_5=@]ø ÇÚ·‡måši%±Ô-“TŠ5f8à;âuT†diY†Ü¶A-àb¸?9^…Gôk›ÒÛ=<î~»‘}#³|-\× í(¥(ÉÒm¥ï9é8·-»$ïef’áÏü}#?¿òÛÿîºÅp2k\GþIÿÛŒ¾•3§.Xä÷ÿ¹þâyo‹?`¿Š<Ú¬¾ño‡u½2Þ/2Ùnk»Æ AW¾Us6ÓÁ%r@àÄðV*›“£8É-·MüµK·Å÷[“}'r,\iG1ÂÖ¡RNÒ·-JpWµù¯É%g+RºÕ%+&üZý~9xvÊ}CSðËAÝÉcwmy)É 6Å ŒíÉœ “À&¼jÜ;˜Q‹”©h»4ßÜ›géYwŒÜ™V 8õÍ+ë(Ô„tMë)Â1[iv®ôZ´ŠÖ?>1_ɦAgàk¹¯u[Y,ð}¢g€‘ˆwïó `» îÜqŒñXK"ÆÆ<ò…–ú´¾û½R—Šü3V¿Õ©b¹ç~_v$›½½×5$ÞÎ-§ºmCiÿðN?ÛwT°±Ô­~\Çmw O]ëºM´ª¬¡€x¤ºW°yGPÊr\5£>²E‡œT“v}ÓOîjëÑêoi?ðL¯ÛkPÕ4Û Ï„ÖÚe¥ÍÄpË©_xJh,ј,¢+‰$(€–a;àªÇ¯ªIô4ÿXhE_šÿ&}Qà¯ø#7Å=CûOþ7Ư èE<¿±Â7§Üë^~wyžoœm<½¸nÝû·6ví®8/æg5^'Ó÷po×OóýSðÏügÃöÚíÇŒÿhmSTðÒoûM†‰áØ´Ë™rŒeÄ— ˜rŒs åAQ´ÃUƒ‚Ýœ58%îÆÏ×þûGá—ügöDøiý‰v~ëÚoÿ_^I¨ý¯ÌÞ?gòÙ¾Ô“jÿ£ŒlFûã}k=8ô8+fغ×NvO¶ŸŽÿ‰÷}ly¡@P@P@P@P@P@P@P@P@PÅŸ¶ÆFð¯‡×áw‡ç+â[~Ïm½ ÒäDû]ŽÑ$¬¬ƒˆUüŒccîd¸¬UöÓøcùÿÀÿ/3ò߸©dø—aßï«-t½©»§®×“Ñh칞•Ÿž:>žcG¾îœå ^"íž…cl^+ª1< Õ¦Ö cŠÚ(òêÌè-àV©3™·X­9%"ðªnĽIi4›4Š&U©lÚ1&UÍCfñ…ËH• p¦XT¨lèŒ C‘Õ E•Ú³r:£HGIÈÑR%X½ª\£DyŠ—1nˆß'ÚŽa{ò½©ó Ø´uJF¤@Ñ{U)J‘GT¤c*EwŽ­Hæ"»&*Ó9¥ ²U&a(•«LÂQ!+T™Œ¢DF*“2hiÓ!¡”Ó!¡Ž£Ò›Æ|±Î*Mc+sC׊ͣ¢1® ëÅCG\&aÜÁ×"³hí§3æß¯“Gu:‡=wmœñYI…*–9{Ë@sÅa(žÇ/wg×"±”ON•S‘Ô,‡Í\ò‰ëP¬qwö9ÝÅsÊ'±B±ÅߨãwË\ò‰ìЬq:†7¼W4â{8z÷<çYÒëŒc¸5ÉRÑ`ñVgØ_²ÏítÞM;àçÅýIGœ­®ƒâ;§Çö#c krÄÿÇ©Æ#ÿ©û­û¦œ·4úEGÿvôOù|Ÿ—gÓm¶ñ8Û?Ö¬ó¢ âàœªA/â«ë8[þ^+ûÑާįQµ?Ðßøy."ž)#ʰ äWÚÁs«3ù‹7†šœwGççÆ†i$—D[üÜု ƒ»z«ð8¨ûÇÒ±'íµwð¶ëIøñãW?ð‚¶žñmóÿȲZ]¹ÿ—N‚9OúŽ¿sƒÇc0n Ê'ô‡ñ |6ðËbÚpÔõ >'¼†Üï;!ºÇ ŽÊcu*ÌYH<×*N ±õ¸Œš­.š¯ÔüøøŸÿÀðæ¡õ÷Áï‰Zž…x~×W®›¯/5øœ|?ðJ½vÜŸ´tGýïŸþOªY¤×Cž| …š³¨þïø&}ßü3âŠøŸL°²øÑ¡Mày-ɽտÒç†ú °øX¬„ˆH‹æk”#{ü§`߯ö¼­¶§ðMT÷{Û_ºúýèúkàßü¿à·Ã¹!Ö~ †ø‘âÄ,D¾!¶TÓaÏš¿»ÓòèÙŽDÏi°ñ«§–xU±•ku²>£,á¬Z´4»½¾ïó¹÷ÝrBP@P@P@ͯüÿöSÿ…Cñ üxðužÏ‡~>¿sª,×Þl–ž!˜Ï<ÛcpC:#ʸg "ΧÊC 3Gí£îx[3×êóz­½Í ¾œ×V™úαÙi—I€Ñ>%•HÑ_å´Ô’3)TÑ¥¦üC F~½êýµŽw—s;³¡ÿ…‰ ¤Yr[Ö©bFRÉã)]œOˆü{£ë6:nµ§Úßé³cÌ´½‰fŠLÃr0 á€##¨ˆâªS—<MuZ1b2,.‹Ãâ©Æ¥7¼d”¢ìî®Ó³Iú£å/xwá£Í¨Ïa }’[’íºÎâhÄ.Ù9Dݱ@'… ´` cŠõ)ñaO•*—KºZú»_ñ¿™ð˜ß8?êÊx>YNúÆs\­ßXÇ™ÁZ÷K•Åh¹m¡âÚž™§Ù#­Ž­~²ÿ NÉ Psù×¥K‹qŠIÔ„Zòº}ßä|^?èõÕ(Ê8LMXTÒÎ\“Š×[ÅF ét½åg®¶³æ%½º…µ ÇÊÇþÍ]Ë‹¦ÿåÏþMÿÚŸ+Sè퇃¿ö—þQÿî§=q©\à™.›ëXˉqS“ä‚KÎíý÷_‘èÑðC!ÂÐKˆ©*Š÷qäŒ^ºZ.3kK}§w®›,)õ™Ó8œŠÍføù¶ùíò_äuËþÃÓŒ™¤•Üçwn®ÒJïwd—d–‡1¨ë·/×/Ç¡Åmõ¼]ksÔ-?+‡¸,Rú¾ÿ5ç·nw+oÒ×ë²>ømð ^î×~)­ÅŽœ¾\–Ú4RªMt>W&r2cB¹Bƒl™'&=£wÔe|<­íq©¥¥£Õõײém¥µü#Žüb’—ÔxbJ¤ýå*­7î½Äì§+ûÊ^õ;ZÊ|Ï—è»ïh>Ðì|?áø`Óô[ü»{XNI<œ³I,If$’I$×Ó¼E<55J’åŠÙ_Ó? †SÏ1•1øù:•ª;ÊOvÿ$’Ñ%d’I$’G¤êïÄÍJ ' tI]Zpàþùƒ}@ÊŽxçã®çÉêbðø^¢ñòõ'o&Ó_=þãï_‡ÿ âò¢y¡  N+éð¸Ek³ðÌ÷ˆdäÔ^§Ñ6%­”K1€|W§Æ Èøj•j×—4Ù}­†"¯s]׉5ÿ xÃú¿‹|UªÁ¦øMˆÍs{pNØ× ³1!UTf`ª V5ëÑÁÒ•zÒåŠÕ·ý}Ëvö;òœ«0â,u³-¤êתùcîÞþ‰%w)6£§)4“gäÿÆÿÛÏÅ2·ü ´¾ð®Šû–}fèÄu ¸Ú ¥WrÛašC½¤;cehðÊ6Î8Ò¶!{, tãÕ»s=:oË×TÛÙ¦íŸ>Œø š¢Çq\㊪¬ãJ<ÞÊ-J÷mòº·J>ì£+Î2K©/€a· ø9Lþ³¡†K¡«Ž+žS=z8sB8zqXJG¥J‰~8½«'#Ñ¥FÅÔ¥däwB‘ecö¨lë…2Ê¥fÙÓªT¶tÆꙩlÚ0,"v¥³hÀœ%MÍTIÒ<ö¥rÔKiµIª‰eaÍ+–¢ZŽAHµüV¹ê)\µìv0´®R‰z;3ÆE"”M²~íå%_ìÐ>Rd²ÿf€±#Øñ÷h¸ìVk›â 6Q5­í¹£lAÊA*ÊÀ«+ ‚EzXelhס.YÅÝ5ý}ëf´zÅ<5—ñ6[_*Í(ª¸zªÒŒ¶kuªÕ4Òq’jQ’R‹RIŸÐ?ÂÏi¿¼áoiqùVÚ½¨•íòÍöi””š-̪[d©"nÚmÈàŠþ‡ËñÐÌð”ñtöš¿£Ù­•ìî¯mw?Ç0áLOñ3 Æ;΄ÜSÑsE¥(NÊRQ烌ùy›ù^©œ‰k€¾¿ÓtÛ¯Z_µÐÞ÷¾¥ ¬{d!ä’ËËFbî•KÅN¤iκmÿ/¼–ûµuÒÖßTímOÒxÀ¸‡[…ʧÓéVÔe7xéÔq“Ò\ÜÍ(5EIÍ(?Ê_ˆwšaø¿ñÿMÕ­5=2ÿ[¼¼¶Ô,šã–gpQ™Fð ,¹BT•f\1ù™â¨b15gB¢œy¥ªwW¾ßÖû«¦™ûS†ÄÒÈð˜|M)R«Nœ!(MZQ”b¢Ô•ß+Òöv’½¤£+¥è¾Ôã^ zt&—Í0ÍÜúÃú’‘½ZS??Çá­sÚôDa9¯F”ÏŒÇa÷=§E½ˆ3^„2±ò8šnœ®ŽòÊã泜.uáqN'aa>í¾•ÃV>¯/Äó´tͧ%Ä{ÑzõÃíÜ™õ2Ë!‰‡6ë–Néð÷Æ[¢æ×Wºxoáb’¢´žÄg±=ñœdâ°¥^;KFz˜ü®µ¹è.h=Wé=<÷=§Dø§e)>uðòÀ,Üšï§R›z½”Æaqtâœ"ùŽÚˆ:lØòï“ñjÑÓ¥-™Å f:‡Ç\EsT¸VÑ«?«+ÝŸÛu&š!úà0cëZÆ‚êpÔÍfÕ¢H ~Ìÿ> Æš­¿öߌجâ-VÚhÊ1¸µÿG·ËÀ%È«»€¸øü^aWýçhö_¯sú?‡xC/áÈ^Œyêõœ’¾Ö|¿Êžºjõ³nÈú"¸Oª ( € ( € ( € ( € ( € ( € ( € ( € ( € ( €3u_NðþªëڽǑ¤é¶ÒÞ]NŸÊ†5.íµAc…Rp'°5P„ªIB;½ 18ŠX:3ÄVv„“}’WoMvì~ø—ĺÄox“Çz´^]î±rfe[ìñ(·*¨m‘$i»h-³'’kô|a©F’éý?Äþ-â¬ú¦y˜VÇUÑÍè»%¤V‰^É%{kk½NOµ cšõaàqnÎÆÎßÅtEEj‡EmN+T>r7­¡éZ$qÎFš¨{o© ©-"@3I³H¢eZ–ÍãuZ†ÎˆÄ²‹PÙÕ‘+6θ@´‘ŸJÍÈë…&ZHÏ¥fävS¤Ëk =«7#²4['X¥K‘¼h,Ò¡ÌèŽ})s”ðâ}œúQÎWb:Sæ%áô!h¥R™„°åvƒÚ­Hç•»ÂGjµ#štZ+<}x­ŽIÒ*¼~ÕjG,é™1ô­9'NÅvJ´Îy@–©3žP!+W{˜J$DzU&dÐÂ3LÍ¢221AéØ)O\RhÒ2&ˆñY´tÆF4ðuâ³hë§PŸ·ëÅCGe:‡?soÔX´wÓ¨s×v¹Ï”¢zªœÅå¦Aâ±”OJ•S”½´Èn+ DõhÕ8ûÛ/½ÅsÊ'±F±È_ÙŠÂQ=jŽP³ûÃoÍ(žÖ¶ÇŸj–<:‘\³‰ïá«ìÏ%ñ–&Žhä(À†ýGÒ¼ìE%R.2ÙŸa”fÂV…joÞ‹ºÿ'khö}Ö‡Õ²Ïí‰Ãûø[ñ§QžOYFÑé"ò¤¹—KTÒªy ÀÄdÑœ& e|øˆÖ ¼:^ìtRÕÚÝV»u[m·—â÷‚õ8žœx‹…é[U)N“qŠ©ÍgÏÚŒg­æ›Qž²O?iú7â¯é~(Ñ­µ.êÚ÷O»…g·»µ‘eŠâ'PÈèëÊT‚F+ô*´á^ pwOTÖÍw?ŽðÜFS‹– Á¸Ê2M8É;4ÓÕ4ôiêžçÂ?>ÆÂã óÚ¾oƒNçíœ7Äm8ê}‡ûþ×~!ðï‰<9û3|T»7šáû…5ûË„GÓ]T˜ôù™Øy¾Ñ%ÑÙ!‘ÐCò8Ì/³nHþ‡á¬ùbãû>Þ_å÷z~Ùל}˜P@P@P@P@x¯íð7´OÂü/ñ…«&¡¾›©Ü[™ßEÔ0·½ˆFß6J‡]è^6;$pfqSVfØzóÃTU õGñ¼m5=P¿Ñµ½:ëNÖôë‰-/tûèZ í'ŠI±° ެ*@ ‚5ó˜Š|­£öl£«SŒÓ:;ŽG5æÔöØ,JvGUgtéŒ5rICFgi¦j$ã-Y8ž„*XìtýqíÝFó·ëY´tÆ¥ÏFÓ1À?½ýh°C…Ô<^óeNOSž”Ông*¶9«Ýg0_õ­T:˜O2ÔõC$ŒV‘ÅWdsdä“]¦yŒYÍÞß vÒ¤|Î?0KDÎbâíäqÎÄ*ªŒ–'°èR¢ÛI#ãñùœiÆSœ¬–­¾ÇÚ?³‡ì»ñ§âŸŠ<ðkW×.®£{» Vò(ílcŠ)U †êäÇœJ*’4ƒaÀ]²cêrÚt0Pö•’ç{u·m:?ËËSð^4ÆæœQ_êyt¤°©5&½ÕQ»©.kûгµ¶“»jIE¯ÓÿÁ1¾'ë:£Ëñ_â΋¦hÑO o Ç>¡5ô;žžlé ۾СdÃ,I_— ÕW4”¾x£CøÒ_%þäÌO/ÂïÙ9´¿„ß³œW¿µ8¤mwâ¯qöÝkÃVŽ®#KykœóÃs*o€G …™Y¤ŠexJUqÓ¼þÀž Ç`8Wéalªµ«ÞIyvný-e«èÎà¿Ã}:Ú!À2JÖ?áí_w—àÔüŸÆK8»€-¤^M–—§«Åib¤ æ(Ù˜îvPÌÌÌÇ 3µQWò\Û9ÄæõULCÛD–ËÑk¿W¿É$¡~øm’øy– )ƒnnó©6I½mÍ$¢­í¤’ÕÛšR”¼Î(:q^,¤~™F§=0+ Hõ(Ð4c‡«HôéQ.ǵdäzéRF¦£î—æ×<–‡oéËçY'”“¹ ÈœŸŒ‘† óÝ_™ä¼v²láÔÄÊØzšOKµkòµk?u½m{Æþë•ãüïÄéf|S‰Í±ÞíDŸ2I>H¥ji4£~HÚ-ÚòI·+!á-l·–7s_Òô*îmƒµÏ¦†$|sWVÎL-Ó’>+ø±¤Ýè3¦¹håÇòΪÝìßëõ¯ŸÇStŸ:?aá\]<|£ÕíëØà´ŸÊBb^>µË S=ÜVC}KÒ|vä¦éç]Å>çÎb²4¶G¤iþ=Ø‹ûî~µ× Q󘌊ïc~/ß~µªÅ2ȭк¾9Èÿ]úÕ}dÁäžDSøÝYOïyúÒx’á’´ö9Û¯“ŸÞþµ”±¡K'·Cš¾ñš*1yÀ¤Ö2Ä ·¢<òóÆo¨_Ùé:jÍyª_L–Ö¶V‘´Ó]Lì#Ž5ÙˆP IW\db®ÙõV¯% pm¾ˆý ýŸ?b¼M§i9øê·vÚ}ìI¿{kqµÕDR]ÎŽ²DØ.ÞBaÔù{Ü$5ó¸ÜÞRn>ÿò?e៩QQÄæŠï¤6ôr{ü½.÷GêFŸ§Øi6ZV•eog¥Ù–öÖv‘,Q[ÄŠ@ ª  `¯ ¶ÝÙú¼!qP‚²Z$¶K²-Ò(( € ( € ( € ( € ( € ( € ( € ( € ( € ( € (á/Û_â1³Ñ´O…tŸézÎÍGSù~í¤r~å>d ïš2ÙV ¿gÁ’¾‹ Â{J-£¢õë÷/ÏÈüoÅÞ!úžE'ïU÷§þýÕªûRWºi®K=$|3£Y…T8¯·§ùoZí£½±ƒ¡"ºb ¼ÎªÖ.·Hó*Èè-¡qZÅ5$lĘVˆånìœRcH‘¢Dª*6Š'U©lè„Kh•›g]8‘+6ÎÊtËÑÇYJG}*EÔŽ²r;éÒ.G{VNGm:EÕ‹¥fäw‰:ÅíPätF‰a!ö¨r:a@“Èö©ç4öAä³G8}\C)ó‰áÈj¥3 aÊïµZ‘Í:Y!ö­Ž:” oµh¤qT S’,v­TŽ*”lS’?jÕHá©H¦ñÖ‰œS§b»-Zg4àVe«LåœHŠÕ&bâB­3!„gëLÉ¡”Ó!¢¼©žÜPÇc:Xp*Z6ŒŒ¹áÎx¨h脌iáëÅfÑ×Nf Ìx¬š;éÌÁ¸ƒ¯›Gu9œíÝ¿^+#Ð¥PåomúñXÉ¥‡){kÁâ°”ORS½¶ûÜW<¢zôjf£gÔâ¹çØÃÖ8RÌÜW,â{¸jÇœêÖ•ÎÞErTô8Jí3Å¿‡³e‡µ¿ëËÓ·oÃòæÊè¤6Aï^%Zgê8Z•šgWmv0kÏ6}v’7¬ïv0ù¸5ƒ‰êB­ÍÅÔö޼ÿ*‡ª5¬M³4vCô©å5U†\k3K÷¤8ôÍ5J²F[êEI!«HÀ⫉*^jå¡ 75ªçÔÄœÍè%¹®ˆR¹äâqÊ=NzçQê®ÊtœÅæ{Ùž£ð/öwøÃûMø¦ëÂß |5öö±òTÕ®æ[k"d¬—7ü „q‡•Ö) Fû;–ÇÅfyÄ(ë'©ý-þɰwŸÙ_LþÑÛkãв\I3øãSÓc†{D+$kŒe¤6©åJêå\¼¥Û{òãÔ§J4Ö‡ÃâñÕqr¼—cî:Ðâ>1ý²¿i«o~ŸÃÞÖm×ãV¿ ®göu»60™6É{4d…UU¬EزDIBõa0Ï?#Àâ îžO‡r¿ïËõ~]»¿™ùðËÁ—·×³ë:ÝÍÅîµ3ÝÞê²4Ó\ÌìYÞI–v,Ä–$’I=M}Ö_ƒPKCùO‹øŠx™Éó]¿ëñ>çðµ”¶ñ[Ä›P¸êkè#%d~A^„ñu'¹é[²Å‚*¹îÌÞÆ/CäÚGö´ðOÁ -WÚUÄÏÅuŠ?³è@9ŠÌʤ¤·r.ª¨ å°xøU5| çˆheQ”"ù«tkõoôÝé²w?\ð×ÁÌÛ«RÅV‹£—]óUÒòåjñ§«méÎ×$Z•Ü¥GøaâOø‹ÆÞ"Õ¼YâÍZ}OÄZœ¦{«Û’7HØT( ª *ª…P~KŠÅÕÅÕ•jÒæ“Ýÿ_‚Ù-ô'!È0œ0ß-&Æö%Ij®CFEÅž3A-Ó[òx¦™ òCŽÕD4gÉ^8¦™›ELgҨ͢«¥4Ìš*ºõ«Lç”Jr/QV™ÍR7(ÊkX³‚¬ [ÈC=kª”¬xXê*hûŸá^µâ/‹×x߯ZÔÚ¿ˆƒ 9ç™"1•QkÂ7HÄå‹ðÞ!ç¸Ü^3›7&â¬ôÛÉ-·è®îúŸç?‰œ=…ðï<.¢©aÿ‰›wŒÛÕ·)I´Ó…äïh«Z6Gݾððbù9ãµ~:”±u¼Ã–:¿’?2þ2ø6_†¼YáñlÖúUÄãQÓñiöX¼ÿ¼ ô1ÆÌðî^3  ìN Ì¥˜äøzµ梣+¾gxév÷¼¬¥®¾÷]ßô~[RXü¦JšÍFÎîí¸évû»skß®çaá-MYcÆM}Ý ŸšášoCÞôÿ¹óW©JgÂã¨n{w‡õ¹óW¥JgÅcðûžÃ¥]¼Š…Nî‹ocåêÓŒ_¼wÖº…-Ò‰+­I¥5 ^,õ/Ý!(KWŒ¦õ?Lá¼\]®ÏI–âÜÀ…›œW‡IIŸ¨ÕÄQtcÌõ±Èk1ÏL¨vž3Šô°Õ\eÊϊβúu躱Z!â 93'ïÆ§4u?#¯„öUœb|é㯠Û_ZΒƬ„Ak›IT‰íåê˜JªÏSäÝö,øýãZñ—Âm?Lñm­6–ºRêQÚ^Æ¢›Ìo´ˆÆ¢DL‰K–9ÙŒ‘ðØÙýF»¦Þ›¯Cú¯†°Ïв¨ãiÇÞO–KEï$›kegué·™“®þÏ?µ75}+_øã ‹É`[…}Áµ¨B–eÃOgæÆ¯”9BÁ€*H”™§˜Aõ/¨»*Oå¯åsšñ%Å?‡Úu¾±ã.ðÞ4ëkö½£]XC$ÅY„jò¢©r¨ä(9±ìkªøKDÏÂ8ŠkštÚ^iœý§ÄëVÇúAäŠèŽ5w<м5Q}“¬ðÿŒµêö~𖛨kž#»ßö}/G¶’îâ}ˆÎÛ"Œm¨¬Ç€¤ôÞ>WlÊŸ bkË–Ûo²=O~ÐÿÅŠøG ð¶£ÿÆ«7™Òþe÷Ñàlwüø—þÿÈú?áOì[ñûâ$¶×ž1±‡À^š®ïY+s{"ɲ„²÷+«ÖD¸x<Î2²JÙÌ"­v{ùw†˜šíK%N?{û¯÷Ý£êÿÿÁ7~C7Ž<{â­{T¶œKw‹Á¦Ù_ °ˆÂI‘JmF+>ãó2²dójæµê^ÖGÚà|?ÊðŠ.nSk}’+_ñ>Íøið{áŸÁí*má·ƒ¬4KYñö‰  -ÅÞG_>æBÒÍ´Ë&ß1Ûhm«\*Ϋ¼ÝϯÂ`pØ{<4W—ê÷3Òk3¬( € ( € ( € ( € ( € ( € ( € ( € ( € ( € (  ×·¶zmÞ£¨ÝÃk§ÚÄÓOss Ž8cPYØà*€ $ð§¹4’»dT© 0•J’QŒSm·d’Ý·Ñ.¬ü<ñ‡‰¥ø‡ñ Åþ8•¦hõké%·ûLQÅ$vÃä·Õ>]É D„‚rW$±É?£åøo«P…>Ë_^¿‰üYÅùÛγLF6îӓ当QZE;iu“ßÕîmé¶ø ÇJõ Ïq55;8ºq]G‘ZGMm­R<ê’7`V©sf€OC4=Gz’Ò$QIšÅT6tB7-"Öm”à[E¬Û;)Ä»VRgu(¥c&zT©—£8¬œB+—ã‹Ú±”F•êÅíY9ð¢ZH=«73ªž¸{Vngl0äžGµO9¯°òÈÏQG8þ¯p6üt£œB»ÁíV¤sOUx}«E#’t µh¤qÔ R’.¼V±‘ÁV‘Ÿ$]khÈójÒ(Ik}ZE)#ö­TŽ ”Šn•ªg HXªËV™Ë8•ÙqV™Í(0«G<‘ªFM "™›DddU" ò¨#§4˜Ñ›4]x©hÞ1®"ëÅfÑÕ wu¬Ú;iÈĸ‡9â²hí§3îƒÅe$wR™Ë^A׊ÆHõ)Læ.­ºñXÉ•*‡%kŒñXN'«B©ÆßÛd0ÅsIÅ –g¨ZòÜW4â{¸z§©ÙcwW,â{˜jÇ–kúnå‘vƒžFk†µ5$ÓWGÕe¸ÉÑœjBMI;¦´i­š}èxޝ§„g\qÔgÒ¾'EàëºwÓuéýhPåŒ8—,Ž7•)«ÆI^ÊKµú4Ô–®×µÛLýWý”>3KñcÁÓø;Ä÷Ó\xëÃ1/›wy*ø­¢ñ>pó[‹ÈÐÌŽ±Hœ’E$ˆJ•`•e`|¶7 ¤šgï<5ŸJ”¡(½Qý3üøÃàOŽžÒþ!|=Õ~×£]Öó—:uÊ€d¶¹ŒåÊ›—#$ÊèY¾nptß,Û°Øšxºj­'tÿ«3Ô* € ( € ( € ( € ¡ªéZ^»¥êZ¹¦Úê:.£o%¥æŸ} ÏÜ)GŽHØte%YH ‚A i´îåŸöûýì­ñÓZð.ªÉð?żÓo.GzL…ôÖ›s;mDDÒ…g™s+A,‡ËÅáí¬O»áìåÉ{*Uý\ø†Öàn xÕ ~‘„Ķ“¹½oq€9®IÀú>&ËsAn:|Õ“‰èÇ™0œã;¿Z‹*«¹·zª01«ˆK©™5Øù«xÓ<ÊØ´º™77¤)ù«¢µ<|V:Ës™¼Ô1’Z»éQ>S˜Ú÷gêoì¡ÿ´ø‘ñtÙøÏãÙÕ|ðíþÕè~Y´ñ䉄¼™âd¶„¹sºPdaA%I‡¥K ÖGÄcóÇwNïð?¡¿†ÿ ¾ü𽯃>ø7Kð߆ ÚßcÒàùò,i3ýù¦)a¦´´by®Ô”U‘ó5*N¬¹¦îÎö™š|cø›¥|øaãO‰šÌ>}®…ffŽÓ.¿l¸fÛÁ½Êy“ïð/Õ,agP¹Å}M*°»?Çf®¶%Æ:ží¤øvÞÙW ’;š‰Ê1:°ôªÖÕè‘ÿjOÛÃ_nÁ¾Ó­üCñ&XKÉbÓ”·Ñ•£&).J‚Y™Š0J³G–/hËüæqÄTò¿ÝS\Õ;t]¯þZiÕiÙü9ðsÇ_íØ¹º$íÍkÊ¥Ÿ¼¡}JéÔi¥+%µ5ÂcVÕ%×.~Ó­ê×s_^\ùk<®^GÚ *噎3À¿/ÄWz’«QÞRm¿W¹ýß”åX|« G„-*QŒ"®Ý£”UÛmÙ%«m¾¬Ž(zq\’‘ïÒ¢iE1Åa)6/ÇJÉÈôiÒ.GL ɳº2â%fÙÝN™iS›gT XT¨léŒ ™úT¶tF%”NÕ ›F%”Ž¥³hÄ´‘Ò5Q.GqÇ-š(š@N8¥sERnœT¶h‘¯ogœR-# µ²Íñ_Dµy4}BÛb½ØP\YO¸ª´R1;Y˜yNÛÁÚdI?hÉóHðÜ! ¯÷rk™véÌ­}W’Õ+v·íTçC$ÂÆ5^%ÜüFð^µ#4aŸqŠýPâÎpi'd}A j[’&ÝÖ½šS?3ÇáìÚ=¯ÃÚŸÜù«Ñ¥3ã1ømÏqðþ£Ÿ5zT¦|N?kž§iu¼ÇÏj铹ãS"gw£Þ2x5Ç^Ÿ:>)ż=EØõ %ëÆY¾AŽ+­jIÛsõ\¹O(ó?t쯴ø›K Ï5æÒ­/msî3 ¶›Ë”Vç‚x†Ä«K¸p+ê(ÔçŠHü#3Â,=iÊ{#üKaæZܾõÙ({‡ÌÑÄ[™ìŸ±/ŠßZø‘à ½D…‘`Öl4ÿ#¸&©|À¿õä»Y½Ô}ó_Ä”-8UKÉþkõ?®<ÍL6#/”¶´â­ÿnÉÞßàVoÑn~„×̺…P@P@P@P@P@P@P@P@P@P@P@P@ù)ûCþÔ>(ñ߉µß‡ÞÔ¿³þ[ùº}ÝÅ«E$šñ¿œ¹Ûnv‚6b3$?–ŸY•åQ§ËVª¼·ôÿƒù=¶¹üùÇ|}_ë`0å ¯Õ›žº»«Ú.ÖV~ô[æº|«Ã´‹@¢4¥}]8ŸÏøº·mž…càW\Qóõæu–‘`/¼QåU•ÙÐÛ§N+X£†¤¸“´Hånì˜sIRÍb‰”T³h¢Ê.k6uÓ‰m³lì„K±¦k)3¾”.^Ž>•”™èR¦iÅqXJG©F•Í¢éXÊG©J‘¡B°”J•#B8½«#ѧD¸‘{VnGu:%ór;aDCíSÌkìyÒ—9J€8éG0:wƒÚ­Hæ£ÃíZ)s T’¼VŠGZ|°ûVÑ‘çU gK^+xÈó*Ñ3¥‹â¶Œ2­"„‰í[EžuZe #ëZÅžuZe'\VÉœ…ŠÎµiœ³‰Y–­3šq #µYÎÑQ›CÁ Í‘²ƒU¹;eŒb“EE™Fk6ލHĸ‹“Y´uÓ‘4CšÍ£²0îbÖm´äs7u¬dJŒÎjê¼V2G£Jg/}ox¬dR…CŒ¿¶ûÜW4ÑìP¨q:…¯Þ8®yÄö¨U8J×*ÜW4â{Xz¶gškV{£~9ÇR'Ò`ëY£Äx²ÇÆ~ ¾û>§o”’)ho!$†do°22 2•eVfe[/¬«Ð•šûšìü¿áÖ©3ë¸ç‚rÞ/Ëje™¥>jrÕ5¤¡%{NÎÒWÑêšn2N.Q²¾ñ§‡þ0øFñ¯‡æ’ê[»(¥26ŸtmÜ•S¹ c%Få*àme'ö 6.–g†Ž"“ßuÙõOm½5ßfœßc¸;¯“ã¢Óƒ|’jÊ¥;¾Z‘³’´’ÙIò»Á¾h´¾ñï‡<ÄŸäägµyت7>Ó"ÌyZÔõŸØãõïÁŒP|(×[€>"_Ãh¯,³·ö^ªU£·’(2ÿ¤;E‡jž!v‘Våqø¶º¾ð–n®¨Ié/ÁÿÁÙü»Ð}yè@P@P@P@ÉxóÀ~øŸàýÀ>>Ð-u¿kvæÚûM¼¤ÉAÈêÁ]$RU”«(!4¤¬Ë„åJJpvhþDÿiOÙ«â'ìñ_xå>ÛáûÝóè)¶„¥¶µl¤Ê >\ɹD°Z6e ºZiݨ4`1ÀªHÍÕ±³¸ûµJÄ$Z](vŸ!N4¡ÙJ~̇Š´¡·¥‚X›²”šPþè©p5Ž!¥Ò‡#mK´qÅ»Òzüµ.67E#šºÒzü´¶/Fr׺Iç úS¸š9 Í8‚À­2Z9{Ë¿-4r·veIÀ¦™ õͶsÇ4ÈhÁ¸·# Šd4dJ˜È"¨Í£:húÓLÊHÏ‘zÕ#ŠnµhÂh£"õh䩌ɚÖ,à­ ™™­åŽâÞWŠâ&±±VF ‚:yÈ®˜ÚiÆJéèÑóyž–*”èVŠ”$ši«¦š³M=kFžçèwÁ?ˆþ,:-¿Ž< ­Í¢ë«#[ßÛZeà3"7Å"”l”:†³Ìàî\׿„ªðþ=ÐR¼lœ[¶©÷ôi®—µì®ó˲ªþñL±MÊ”éÊ\·”%{]+«ÆJPm¨ÝÇ™E&»|9ûG]|C‚mŶֺo‹ãÜë d·½“˜ƒ3ey ¸n Åæõ1T=·N¶è|§gµ±˜¬=ºÛ§üósöðæ› |D_èå’;½Ý¼pªÅ ʈPeÉb%•Û'võ/ 8’¶ež_‰µèÛ•ÝóJ ½É¢Mh¢ã+]úÜ›VÍòéáq ZVåwwqwѧü»&´³Š²µÞg…õ€énÍ~áF fx;6Ïtðþ¢ABOéR™ðøü=î{¿‡5va«Ó£3áó=®{F“vV' ®ø»ê|h8»ƒ¥Ì]–¦KK›Ðª”ÔëÚì»n:Ò¼¼U%RƒÙ¦¾óî²,|ðXšXši9BQ’¾×‹M_m4îyuå¾C)×çëš”ÜeºÑŸ×ót±¸xW¢ï ¥$öºjéÙëªï©õ_ìWñóCñî£ðÆèÍ6‹âx¤žÚ5,Ëmym!| Šð¤ŠÄ+34pŽšûîÌ% CÂKXÏUäÒ¿~ª÷ÒîÈþEúHp},VS"¦”jáZŒž‰ÊI(¥ð¶Üfâ✔b¥QêÚ>êñ†² ‰OZûœE;ŸÊùF-Å­O‹>"ø{þ>T'\ãë_;‹¥¹û/f ¹ý ~Ão>3þÍþ ÖõÍWûCÆ“ÃúÔì'25ͱ7–II2Í%³ÚÍ$˜3ÊßtååkÃÙÍ£÷ì«õ¼,fÝÚÑü¿àYŸ^V'¢P@P@P@P@Ä…ßþ/ø^ëÁŸ¼¥ø“ÃSîo±ê <‰7‹Î…þü3–@³FVDÜJ°<ÒiIY—N¤éKšÌüœøýÿ‚ðn¸Óëÿ³gŠÏ„õS·þ)oÍ=æ™'ú”ýÕÖæ *Ï#oÝÕWÉQÇ-\$'±ï`8†¾®}Wãþ_‘ùÆ?àœ· ßùrèŸü™\//‘ôë‹è¥kþ ðoøgÚ€õý›~)á©ÿñšŸ©K±¿úÏIý¥÷ÿÁ=Ïáü¿ö³øÌ/§ÀðƒiV»ÓíÿDúG2ùgËŽßÊ{–Ê˸IäùGËuó7.Ó­,{œXÎ(§h;¿-à­ à‘³Ÿ„`†ç⎯¯üDÖšÞXgŽâåô}?y”2KÎ'GXÀBæDmÎÛA*ºh@ùLNu‰Ä=¿ëî?K<àü8Òî4?‡ž ÐTõZiwªÑ;kdÿõ««©ÕåíÔ×Z…Ì$·72$žV$³»œ–fbI'’I5÷î*œb¬‘ü‰Õ1•åZ´œ¥&ÛoVÛÕ¶ú›µòÒ1Ž€VÔ£cÌÌ*ó6ÏSÓ¢À^+ºù|D®vviÀ®ˆ£Ç­#¦¶\cŠÕuFo@¸µGÙr†J$&QPÙÑXQPΘ"Üc¥g#¶’4#ZÆLô)DЉzV2g§F&œKÒ°“=Z05!N•Ï&zÔ)šÅXJG¯B‘­ ]+žR=ŠãVG§J’4"ŒqÅc)•*iÒ1éY6z§¡0ŒzT9 ‘(Ú¥ÈÕSÇíG0åHâö«R9êQ*<~Õ¢‘Å:E)bÏjÖ28jѹ—4]x­ã#ɯHÉš>µÑ5zFTÑã5ÑEjv2æNµÑy5àeLk¢,ñë@Α+dÏ6¤ R-j™ÁR'ªg HØ®Gj³–H…Q„‘YŒ‘lk Š­ÄP•r*M"̹ӭCGL‹<}k6uBF%Ìx'ŠÎHí§#æ<æ²’;©Èç.¢ëYI)ÕÜ}k#Ò¥#Ô"ûÜW<‘ëP‘ÇÞCœñ\òG¯Fg¨Ã‚x®y£ÙÃÌà5xzœW-D{ØIž=â[l‡8ê+Ï­ë²ê›Ey¸¯Ï³*~Ç5Ñ»ýú¿ÆèþÂà¼göŸaj6¹¡F—NGʯ«³qQoÖé$ÑÏŨê>Öt¯h÷gÕ´Û˜¯-gدåM‡FÚÀ©Ã(8 ƒŽEk‚¯:3H;J-5êµGŸÄÙN2ÂÖÁb£ÍJ¬e +µxÉ5%tÓWM«¦šèÏÜ3©Ùø·ÃŠ´èfOÖl`Ô ŽåUdHædPàà 3Ü×íê¤q4cZI&¯Ù«Ÿå­Ll—1¯–âu(NTäÕìÜ$âÚºN×Z]'nˆù³ÇúPd‘¶úדŠúCгHö/ø&ŸÄK~Òº·Ã‰¤¹þÆñþ—,Io2}¾Í^æ)evâ,ùBrÒ¦å8 Ÿ)˜S¶½èÆs?fþÒüV¿•Ïè2¼£ï‚€ ( € ( € ( € ( € ( € ( €?ÿn‰W?¿h›ÙÜ[MáO‡±f[5¬ñ\$·Ó,rÞH]T2:°ŠÝ¢fmhÇåfuA”Ð÷yßSòsoÞ¬<^_‹ßü­ä;án‡åÛFv~•ö¸:v‰üÃÄxÞz¶¹õæ…o§é:mÞ¯«Þ[Øé60½ÍÕíÜ«VÑ"–y$v *ª‚K“]5ëB„¤íoÀñrœ»šâ¡J”\œšI$Ûmè’KVÛÑ%¹øQûYþÓzÿíã[­'M¾ò~h7’¦‰§ÛyŠ—ÛK ¿œ:«4²&J«(ò‘ö¸Èò~EæóÌj´ŸîÓÑwó~oðÛ½ÿÑ <<Ãpv*Bøº‘\òv¼ogìãf×,^í7Î×3vQQùj«ç¥#öJ4(£éXJG«J™~4¬dÏB•;Q+&ÎútËhµ›gl"ZE¨lê„Kµ›gLbXUÏ-E”_j–ÍãÒ'j†Í¢‹h=)$hC$*[4HÔ†ãŽ*[5HÙ··èqRh‘ÐÙÚ†#Š :Ë;1ÆIiU‘8â‚Ò:Ë<œ|´ŠHìôí4ü¿- ÜRÓS¸´ÓF媱“šHé­tÞŸ-iœUk-¦›Ó季ͫ\߇NÉ-h qÏlA¦tùkEŽx“j 3§ËZ(sÄ—FœðÕr¼@á§gµ>A}`S¦ñÈ£ ¡6Ÿ×å©p7…s&}<ð.²Ó,J_ð®ì5Kœ™æ‘·céÏ Þ«æ½ª2?4Ìhî{ç‡ï~T¯N”…ÇÑÕž½¥L¬ŠÂ»M9Rr„¬ÏAÒ.|¹æ²­hØô2ÌO²¬™ëºñ,¼×Ïc(è~ÃùƒrZšž hO½•\ø?qž¿¯¬G}ãì{XÚ¾› îóêj3±óOÄ+35½ç‰©ÅFé›dUy'õ à&­§k?¾Ýiw}´:%­“>ÆLMo‚UÃ~YbuÏCŒ‚AþUƒ§Š¨¥Ýþ:¯Àþþá¼×ÒWQ[èÏ•õæÞ[ÂGËÆ½9ë$†Ã®Zr‘Þh±aŠê¦-OE°Nºâ®Î¾ÍpoɬΒÝzV±8*3n 0+Tr=˨©cDƒ¨¤ÍbNªÑÊ• ê‚.F+)Ô‘¡éXÉž$iµ„™ëP‰©ôâ°“=j15`QÅsÍžÆ&¼+Ò¹¤Ïf„MXW¥sÉž½šQ'JÆLõ(Ó4bް”N•"ò'åY6zé–V?jÍÈê"Qô¥Ìj© c¥qºd/µR‘Je9#­TŽ*”Š2&3ZÅž}ZfdéÖº Ï&½3të]g‹^LÉÖºbϼ ™“­tEž=x3-tEž=x™r è‰äÕV)H+TyõFAÖµ‰ÁQVˆã’!aÖ©I7Z´a!LÍ= 4AJN†‘hΔpi3h3&u¬ÙÕb\ÍfκlÀ¸^¼VLï¦Î~éG5”B“9›ÅàñXÉrWè0x¬$zÔÈ^'Zç‘ëQg¨Æ>n+žhö0ò8V,«q\³G½…–§“ø†1½pÕGÔåói£Æu‚ÊàWÃq >ZÔê_t×ÜÿàŸÔþc=¾[ŠÁòüR½÷ç­ktöw½õ¿KkÆjqe ÇJó(KSî³Z7‹?VeOÿÂUðC´–[Éït ›&y¯ví­æÄ±Äùi ð ØT Oì|5ˆúÎYîÜ‹¿Þ­ä“KåcüÙñ³'þÄã|DãÆˆÂ¬TtÝrIÉY.iT„äÚ½ù¹›»ijxâÃt3|µ×‰Ž‡’×´‘ó_…¼b~|føeñ1î5(l|;®Ú^Þÿd>ˉ¬ÖUûL)ó(o2,e‚°r¬v“_1Ž§Ìš?sá\o²© 7³OOÇð?¬JùÃö€ € ( € ( € ( € ( € ( € (‹ø‹ãßü.ð7Š~!x®çÉÐt9/' ñ¤“$1yŒªÒÈåcK Îê¹ÉP‹œ”VìÇ^jR­Qéëô?œ®±âcRñOˆî~×â-nòmKP»òÒ/´\ÎæI_b«—v8PÏ ûŒ¨£ùgŠóIb+T©'«lûÃᾄÒGÊ1šúj0å§sðÌÇ«bù^§ÇŸðQŒº¦‡¥øwà&†žE޹fšÆ¹4¶èßhn1k R%}m#¾’ E?ÅÙ„©òá!ö•ߥô_z×å®çõŸÑÛ„)b^"ÄoJN4›V—/¿&­¯»4£«ZÊñº‹?&!ŒqÅ~{&aФh“¥sÉžÅ(¦¬dÏJ”,\k&Îúp."Öm°‰e³lê„K *ÓXQRΈ¢Ê-C7Š, ©7Š-¢ô©6H»dJ–ÍbXS¥&j‘±op1ÅA¢GCk$ Ph‘ÓYÚm#Š–ËHì,-  ´ŽóNÓ²"‘v;{0|¤­’îŽÎÇOQŽ*’¹”ê8­NÆÒÉxùkhÄó*ÖgGkh>ZÚ1<úµŽ–ÎÏ8â¶ŒO6µk=>ZÕDóêW6 ±éòÖª'JæÄ6–­Dãrذöªå2uÇ‹ÝJ|¢öâ5ˆÇ K”s:kÏ.'D+™3Øã—}ÙÇ_¦Qëæ¨½OÛ³^,û£ö ¹¼’ËâÖœ÷S6ŸºtÑZ´„ÇŽ.UÝW fF $"ç ¯Ôx&r•:ñoE˧¯5ÿ%÷ÁÿIü=*X̪¼`”ä«EÊÊíEÒqMîÒr“Kdäí»> ñ|!£œØ×ÔWWLü)š>'ø‘h­ÀÚZùÜ\tgìÜ;U§úýžµ=KZøð;YÖu ›ýbÿÁú5ÍÝõì­4×3=”,òHìK;³KI$“_)QZm.çôNT)É»·ùÁPtP@P@P@P@P@PÅŸðP{í6ÛöSøa}¨[[ÝjwzM­œ3ʨ×s BÚc@œ»ˆ¡•ö®NØÝº)#«¯^'…ĵ<®³o¢üÑù#ðêÌbÜcŽ+ïp‘ØþIâß÷ÇÃèvZ[û×¼Õ¨Ÿ”S—6b~~Ò4ÿ…‹ñ÷â·‹}>âÎm^[;K­)·Áskm‹[yQ·0mðÁ–k%@ø–qˆúÎ6­K¦¯em¬´_‚?Ô/ ²oì^Àae*jRRV’”ýù&¬­iI«5t•Þ§’Â+Å“?L£R%¬$ÏZŒKÑ­bÙèS‰qfÙÛ–Vlì„K**ÓXQPΘ¢t5ñE•,Þ(²ƒ¥K6H»çšFÉ1/JƒTk@*Y¢Fý¤]8¤j‘ÔYAÈ8¤ËH묠ni$wzm¢€§™Hï´Ë\íâ’(î,­~ïIT•‘ÖÙZýÞ+hÄókU:ëK^âº#É«Té-,É#ŠÚ1<êµlu–6=>ZÚ1<ªÕΖ Ÿ-l¢yµ+›vö=8­TN:•ͨl8-h qN¹lX³UÊeíÇ}‡Ð 9Eí†=v“‰J¹›5^*\NˆW1®,úñY8”ë7V}x¬åº•cœ¼´ÀQÖµ‰ÁUS¯º Ï#£î¿ØÅ#þ+ÿÜßõêöV>OÖ+™7…ÿ¯Aµ›ÝGÞ5ù·‰8hañ±xIßçkÿT½^ÇñÒ«‡í,¿<§Où¨Îwÿ·éG–ÿõõÝ/)?…_xŠ.â¿,»3ù+;ß¿ÃðëâDž.Õ´Ë™|5=“é×—¶Ê\Ù+Éù¢0 )ˆnUù‚’@b7ô‡‚Ø\W·¯ŽTÛ¢ àåÓ™¸ÊË»²»¶Ê×µÕþÛVzÂN¢ŒÛº]÷_-ôo¯Í¯ŽÿiOXø7öžø©£i×Ík.¤š“5Ã+7›w wr€Ñ$îc!@“’e«îâ%n÷ûõ?_Á7W(¢åk¨òéýÖ⿯™Üø.ç}¼#=1^ÆZœg4í6}áù¾ç5êÒgÀãá¹íÚ Æs^6|f6Û=kN“th{Šéz£ÃŠä¨wÚTÂ4,kÍÄFîÇÛå•8ó3rŒ¯…ˆ®YG•j{ÔkûiZ%=r‘N;V˜Yêqgô=ÔÏñ|eâ¸û¦½ >ecä(SöSŒ§¿bˆ¼¯†~,__Üü•´¯Î8‰[¿Â¿6ix5.~¨ÿéì¿ôŠgØuàŸ­P@P@P@P@P@P@P@P@P@P@P@à_´î¿/‡þ øÍíu(lïõ‡N„JSuÂÍ*$Ñ"¶w1€ÏÐn †6äzYE/kŒ¦šºZýÛ~6>'Ä\{Ëøo8MFSJ ö×™¥$“ݸsmªIµk\ü‘œ­@ö¯ÐÞˆþ9‡½Pã­W}ü¬}kž?ëÕv¤‘éºJaR»)Ÿ7‹z³½±ÅuDð«e¨àVèòªîoÛœ­QÅ3b?»WÐçêJµ%¢E¤ÍbYZÍ0-%fÎÊeØë9Ô(»V=J&¤#¥sÈõèÐŽ•Ï#Ø xOjæ™ìáѱé\Ò=ºÖ„p+žG³AQÖ=JF”U„V‰¡àV,ôi¢ÊŠƒª(™jY¼PêE4DëÅRfS‰QÅhŽ*ˆ£ ­bÎ ±¹•:õ®ˆ3ÈÄDÆœu®¨3ÂÄDÈœu®ˆ3ÅÄDÅœu®¨!ó޵ÕÃÄ#&QÞ·‹<б(J:ÖÑg›UÒ Ú'›UVˆã‘ ´sIÛ½Z9ä2¨É‘Јew NaÅ Ò&Dã9¬ÙÕáx5œŽºlÁœu¬ÙÝézÖR;é3™¼^µŒF‹9;åàÖ=Z äoïV=j,ãõà×4Ï_Î R+×4Ïw õG—ëQäH=«Š¡ôØ9jÖSœ{Šùœö)àæÚÚßš?oð¢µHq0“JJiÙŸutŸTžèâï—†Õñ´™ý+ŽŒú_ö_ø¼>'ÿ±jãÿJ­+ô> ÿ|Ÿøþ•øëé8¹xs ÿê&új±÷çŠâù&㱯¼®%åRÕüB·,·#|þ-n~ÃT³‰ûÑÿë]¿±ÏÂôm\åVö¾KüVBdÎøo×ógÚõ‰é…P@P@P@P@P@Pçüâ´|ør„tñÍ™ÿÉB½ ±^º>Cçìò©?5ù3à‡–¼@1é_{„‰ü“Ä~#é_xú„Ÿügñä·KM–[1w’Å-ãb;hÝcÃyÞ$8#‰, Ùž)`p+¿²´õÙ-;»#åø"Ÿñf*ŠmUšR³I¨/z£NZ^0RkG{Y&ìŸó©kJü"¤®¬8JvI/Jæ“=šQ4¢ZÂLõ(ĺ‚²g¡[AÞ³lë‚, ¬Ù×XQPΘ"Š–tEb¤Ú%…ñE¨ÅK6‰¡™¬MבRknÙ: “Tt–qýÚFˆê¬ãûµ&ˆë,£åx ´z”™Û‘I”GÓ`SŠH$ìŽÞÆ/»ÅmyÕª¸;x®ˆ£É­Pì,íA ÅožMj§Yef8­ãÊ­Yu•ªŒq]G“Z£:K{eãŠÙ#ΩQ›0@>ZÑ#Ž¤Ùµ –´HãœËbéNÆ^ÐO zQaóŒhF1Š,53:âÜsÅCGE:†%ŸçŠÍ£¶CêÜsÅe$wR¨ÎVöÏ„‘êQ¨r¶ãž+ #Ö£Pão­þ÷Ï${*mõ¸æ¹äb…C†ÔíÇÍ\ò=jo™y©[rÂ’eu«[`±D4pw±gu3Œ¾ªŒ¤ŽZépj‘”‘:õªF2FL£Õ£žH¡ â­“E EkqUFlËkx³Ë­¦zÀÏü[ð~·5Ç“¥ÏqýŸ|^ëìÑ}žÝ—•º™%!¸ÌC•Àaåñ&_ý©”סy%Í9ã­’ÞòWŽšë×gø§Œ¼/þ´ðŽ;NÕaiNÐç—=?yF ~i¤é§m7£»‹ýjñ .¿ðúÈÿ0ðŠòv Ó´·´ðó›ØÓngE$#*ŸsŒþ#é_Û¾䘬›†"ñ‰'^N¬Rw÷%(ߢmGš×vM^ÒºQ‰Å*¸ÏÝ?‡G꛹ùÏñÂÂ='â ™.g˜ÞØÛÊ|÷ßå„EÏDXá@`00èsj–+N©?Óô?¡ø7S‘Z¢W„¥]¥wçy?ø}OEðÖäŒgµvad|Þ{JÍŸFhãg5ëRgçØêw¹íÏÜæ»éÈù,eÏbÑgܪ3]°wGÌâ!Ë+õœ„ª ‚»)Ÿ5ŠÝå8®˜žs«µ8Ån.¡Ð[ŽA­QÃ6kG÷júu%^õ%¢E¤ÍbY_ëY³¦¤íY³²è‡JÊG}#F.ÕŒN‘­ sÈö(°ö®yÅcZÒ¹¤{vl@zW4r­é\ò=Š,Ó‡œV=j:šq\ò=Z)c5›;©²Út¬Þ‡l5'T- P#sMÍ”¤8­bpÕe¶HóêHËœõ®ˆ#ÉÄHŸ=}+¦ð±22'n+¦‹ˆ–†4ç9®˜vcNz×TÌ©MoǪÌùOZÚ'›U™òÚ'U•Ö¨â‘]ª‘Ï"ïVŽy ª2dtÑ ®ô桚DÈœã5›: b\ƒYÈ릌)ÏZÍÐ0.ZÉô‘Í^µŒFŠ9KãÁ¬$z´ÈÞŸ½XHõ¨£Ô \Ó=l:8=Hü­\Ó=Ü2Õa¬¶•ÅPúlØñ]e¿Ò1õ¯›Ïܪ|¿ô¤~ÙáJÿŒ— ÿoÿ驜eéá«â©Ó¸ý™ïŸ±¬ìßÌšEì0iðirj‘Jk›\ƪ‰òœ0¸kgê¿*7?Âß{ÁÊ£Ç^ÉEóy­?[>›|䟤•L8S—)ʵ5I­£;I¶õZ{5R;KY->ÒýñQfÈìkôZìþ3ÊÓº>=ññOôŽ;ð1]O×rýÓõ³þ 9øg¯ã§ü'7¿úA§×Éã?ˆApïûŸÏôGêržðP@P@P@P@P@P@~iÁM4€ÿþxêÚŒbËÅ"Çû29öÙÜùö³¿,Xù¥ìÛcl«<ÖTí^ÇÄñí>l¯šïG·MŸùiêψ>Ê AÓµ}öŸÉüw:ÚÙƒ~ÊêF›ßþ¢6µ‡ÿÈ¢¯ý»ÿ¥#Òðÿñ0 ίþ˜¨~[ôø¼Ïô× jÅÔV=zF”]« ¥"âv¬™ÝÒv¬Ù×Òv¨g\ Ö¡'Z–tD´ª´IÒ¤Þ%¨êY¬MºRÍ‘£QHÖ&í·,* btÖÚ¢:›3ó ’ÑÛiè=h-ö•jYhô4 -8“Sc¶²ÀÛÅoʬuöMÓšè‰äÖG_dßv·‰äÖGeb>ítDñëe¡Àº<ª»§EÍmϪo[Ǫ8j\ÖP8ÅYÊˈQTŒ[ÔvÑLW+IÖ¥šD£8©fð1.1Ï“;)œí×W¬¤zŽVðg"°‘êQ9Kð5„Vƒ¹Å_ÿsÌöhu÷zç‘ìQ8EA ë\ò=z.Èó½L`µBFçœêÃ;ª‰gŸß  Íœ]ð媌ÙÊ]´Ñ”Œ)êÑŒŒ™ªÑÏ"„êÑË2„µ¤N*¦l¼f¶‰æV ÒôK¯ëÚ/‡,$†;íVò(d¸$F’JêŠX€H\°Î8ìkJø¨`°õ15q„\·²M»m®‡Äñ>gG#Ë1Y¦!7N…9Ô’œœa&’m+Ùiv•ú£ö›Zó.çŽÚÜožW¢ä ±8'޵üÝ”`kæªXL4yªT’ŒUÒ¼¤ì•Ý’»{¶—süŽÂµN.¤ôKVz¦»¥G}jó$¡\A=ký+«eså08—B¢‹GåOíº|V°´†â)eƒM‰eXÜ1‰Ì’¶ÖÇCµ•°{0=¯‰ÍÒúÒIôýYýCáܦò Ô”ZRœ­uk®X«®êé«÷Mt:_Ƕ8Øö®hyÙä®Ú>’ÐFvW±Hüç÷=£ALùuèR>;÷=—GdUE õô®Ø³ækA·vô=KF±Žën[úŒ×&«¦}FG—Ãk³Óôß + vÚTu8à×Ç´ì~±•ð¤ewf¾EmzÁ!·)=»Õá*¹Jìåâ ¾(òSVG„xŠ"‰1Çc_EFÒWGãyŠ•:œ¯¹{öH¾Õmþ.ø·HŽð®‹y¡½Õŧ–„K;Ši¯g S·Þ¿àÒ^ãf±˜œ"øeMIúÆI/ý-Ÿ£•ñgôÐP@P@P@P@P@P@P@P@P@P@P@P@)þØÚæ­ð†-BÚXR Wµ¾¸± ñ°’ÜÀ9m÷(yÀÚœàk ¨¡ŒQi5úþ‡æ>-àçŠáÉUƒV¥8Éß³¼4ó¼ÖöÒþóî[Éô¾3‹´8½—ë\ñøf¯ð‘éšIù»)Ÿ5‹ÜïlJê‰áWGWkÐVèòêîtvÇŠÕ575“¥_Cœ‘{Ôš"E¤ÍbYZÍ0,¥fκeèJÊG¡Iš1šÆG¥Iš°sÌö(°ž•„^‹5­ÏJæ™ìaÙ±é\Ò=º Õˆ×<^‹4á=+ #Ö¢Í8›¥a$z´d]CY4wSeµlVm•‰wÞ¦ÆÊw ‹‘µRFS™JFëZEUdP‘ºÖÑGVF\íÖº ##sÖº`xx‰žµÓxÕÙ‘9ë]0CZÄ󪲌ëhžuVT~õ¢8äȵZ9äWj¤sÈaéTfƆš3eW<Ò)¦4™¤L™Î¨gT ;“Á¬Ù×L¸=k&wSFÙëYHï¤s7‡ïV2=*G)|x5„V‚9 ÃÖ°‘ëQG!¨žµÏ3Öܦß+×,Ïw µG–ëm…×F}> jÕ[7-éŠù^!ªá…å_i¥úþ‡ïÞà©âsßk6ïJœä­Õ»C]6´ÞÖÖÝ4|…éáµ|#úôgÒÿ±ÇÆÿصqÿ¥V•ú¾Oüó‰üuô׆ðßöý5XûïÅoòMzûêçòNWQñÇÄp.sèkç±Osõì‚7å?uÿàœZn›eû!|4¼±Óí­îµ+Zêòh"Tk¹†£s’R]ÄPÅæÉÛ/E|ž%Þ«?¡rX¨àiÙoÍŸrVªP@P@P@P@P@P@?ðSk-JãàGƒ/ll.n-tïÙ\ÞMLëi µ¼ˆI)†YbMͺD^¬îË«£åxÊ›©•ÊËf¿&~xü?¸ÿQózWßaYü‘ŸÓÜìÿjÉ7þÉÿ>šoþœmj8Ÿ\ž¯ý»ÿ¥#§ÀÅËâ6þâÿ銇â-¿Jübgúc†4âí\ò=jFœ\XHõh—SµdÎèS¥C:àZJÍp'Z†tݽêY¼K)ÐT³¢%…¨6‰j:–küG©fÑ4b<ŠFˆÞµê* ‘ÒZ7J¢:›"7-Ihî4éíÍ£¼ÓeÎÞjYg¡érd­SØîì›§5¼O2²:Û&éÍtDòk#±ÓÎJVñ<Šú­‘.+¦'‹YM©àVÑ<ʧGjx²<ú¨ß·=+TpTFÂr3Zr-¯U#;&˜ˆdÔ³H™óÔ³¢ÁëY3¶™ÎÝe#Фr÷‡¬$ztNJüä5a#Õ ¬qwßÅ\ó=š}Ô×<^‰ÄêGƒ\òÜö(ìyÞ§ÉlT›žyª½šd³€¿µ3оµR3g%v:ÓF20®z´c#"j¤sÈÏ“¡­Ë2„•¤N*¦|ím̬¸|1âoø”[}¤é7ö÷ßgßåùÞTŠûw`íÎÜgèhÅá~½„«…½½¤eïndÕí¥í~çÃq~Sý½“cr®~OoJ¥>k_—ž.7µÕí{Úêû]´Zfû[û[…0Yçp,r{­Ÿö~•ò~pÔ³\ýf",*æwIÞrMSVné§y©$ìà¶m3üŒÌ$¨á½šÞz|ºÿ•¼Î«]×ÚÅÔʨ½Y™°{šþÄ«RÑ<¬ Ôª¬®~R|T¹‡TøÇâ{ËyD±3À¢AЕ·Oê |F:Jxɵåù#ú“…éK ØzsVv—ã9?ÔõŸ€‘B=«»±ò¹»æ“gÑåc5ëR?>Ì7gµègîW¡LøìbÔõÝ}Êì‚>s÷={ò`¦MpcUϬᚖjç¸ès†@™àŒWÊâ¡gs÷샧ԡâoÝ·®zœæÞáæñŸw¦Û¼*¥b‘BÝ’]–² €NæQŒGÎñE7,2’é$ÿ5úŸ²ø…,îT§½JrŠõN2×åó±ú[_[…P@P@P@P@P@P@P@P@P@P@P@à?µµÝ×ÀŸGei5ÄÈ–“4vñ´Œ±¥Üî@åTVf=©'^–O% m6ßÉŸâ5˜ŽÆBœ[v‹Ó]âÛôI6û%sòFfßjèE~†õGñÌ,õ8ØNËùõ&¹×Ä{\ÔS=+Haµ=+²›>sµg}dÝ+¦'…]m£p+ty5QÐÛ•ª8j#b3‘Z-Ž~¤ËÞ¤¤=zÒf±,­C:`Ë)Y³® ¹¬¤vÒf”G¥c#Ó¤Í8[¥a$zÔ$jÂÝ+žHõèÈÖ‡Ï4{8yðµsIÍ ±7Jç’=Š24bzÆHôéLЉÍc$zT¦_GéëX´z4æYW¬Ú:cP”=&•AKZV´"wIT¨S‘ëTŽ• 28õ­R8*TFdî9æ·‚<œEDcNãšéЦý‡t½B_ˆþ4×â·Î“g¡›9çÞ£dÓOÆ»s“•·˜ä ¼‘‘ŸÑx.”¾±Rª^꟫i¯ÉŸÆI¼u“à°R—ïg[ž*ÏXÂRwµ•H+7w}³·Ü>.¸UŽn{û|CÐþ\Êi¶ÑñÄ[ÄXîN}kç±rÜý‡è¶âF±Gƒ¿áý•>èßÚ?nûVˆšÏäù[>ÞïåíÜÙòþÕåîÏͳv;GÊV—5FÏè ¶Ÿ²ÂSï¥þýSê:Èî ( € ( € ( € ( € ( € ( ”?n=Xñì«ñvÏC³ûMåµ­®¥$~bG¶ÚÒòÞêáòÄ’%|g'n Œ,”+E³ÈϨË–Ö§­¿&›üøÉðçSŠHm$ÁPkï°“M#ùˆpÒŒ¤™ë¿4›ßþÌßt:kxåƒN]Išá™AŽÒhîäüÆ8(Æ  $kžÒ–'*­ôWÿÀZ“üçxSŽ¡“qî]ˆ¬¤ù¦á¥·«R‹Õ­¦›ëkÙ7dÿ-˜=ëñy£ý4ÂÎéÑ7Jç’=ŠR4¢jÂHõ(Ⱥ†²g¡[CY³®›,¡¨g\aMC:`Ë jÑXSRmXSPtE–ã<ûRf±/Äx©5‰~28©6Fݳô5,Õ«Ž)#§³”¼Ô²ÑÕYÎxæ‚Ó;í*còóH´z.™p0y¤‚JëCº°ºµªgJfÔ7&´Lã2èœc­UÌ]0óýè¸r yÇsÍ+@ÏžaÏ5-àb\MÖ³lí§êeù¹¬¤ÎêPg+{2óÍa&z”`ÎJöeù¹¬$ÏVŒÇßH¿75Ï&zô"Î>úEæ¹äÏ^ŒYÄjR/ÍÍ`÷=Š*Èà5S»ž*MO;Õ>ni’Îõ‡ÍA âïÈÜÜÕ#6rwXɦŒdaÏŒ£)óc/{á·Åï6·QÀ÷Ⱦj Ô¨ä~݈„pxHÑJÖ__ÄúCÂк¤~•ëÐGçY¤ÓlúèÁR½ZGÀæ 6ÏiÐÕ¾Jï¦|Ž1­OaÑCa3]ÔÏ—Å5}RÑ `® Íqâ®}C(&µ=Bü˜&¾kÏÛ¸~£V³:=q[+‘É®+´¬}F* }Ñà'Uýå}†úÎ\T•ä|ù¢›«‹_ .l.絜xNC-´†61½Ìi"¤¯:0èÊÌA"¸ó¸)ájß³ü5>“à UL6p•›©§i;5óNϺ?^+òóû´( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € (  ÝgHÓüA£êº¯ŸJÔ­¥³º€;GæE"”uܤ2åXŒ‚ìET'*rSŽëS N–2„ðõÕá4â×tÕšÓ]Wcð»TÒ®ü=ªë~Ôf‚MGG¼ŸO¸{f-K$WrœÇaÒ¿MÃÕUéF¢Ù¤þóøs6ÀTÊñõ°•r§)Eµ³qm;m¦šhp7gÉÔ£nÍÅD´‘ÑKߢÑßèÒå=«ª›<du=ÁóŽk®Ï׉×Ú7·‰äUGGlÝ+hœ³ «G4‹#­&u3X²t5›: ËzT3¦ »¬¤wÒeøÚ²hô)ÈÒ…« #Õ¡#R&éXIµ=s͵ šð¿NkšHö¨LÔŠN•„‘êÒ¨hÅ'JÆHôèÔ4c“¥a(ž¥*¥¥—žµ›‰×¥¥–³q:ãT—ÍqK”×ÛY óiò‘íõ#y‡­5:•‘NY«XÄá«\ óuæµQ<ú•ŒÉæë]‰äâ+™3KךèŒO½S&y+¢<|ES"i:×LQâרfLýkx£Ê­3:F­Ò<º“(ÈõªGI”œÖˆá¨ÊÄ÷­Y25Fd'š³ '4¶4ôªH’œ¬z’’2¦nµ-0F4ïɬÙÕb\¿Zͳ¶œL+—ëY6wS‰ÎÝIÖ²“= Q9›É:Ö2g¥F'#' ÍsÉžµœ…ä¿{šÂLõ¨Äã5~õsMžÆªÍÃk–l÷°°<—ÄSášá¬Ï«ËéݣȮ_—$õ&¿?Ïjû\_"½¢—ÞõÓä×Ü^øU—ýK‡þ³$¯Zri­ùcî%'n’Ri]¤¥}ÛG-¨IòµqÑZŸK™T÷Y÷Çì=¢ýÁßüWöÍßÚ:”:Ù|¼yfˆÉ¿vyÝö¼c_Sž?Ràê<˜jµ¯ñ4­þý»ð?‚þ’Y—Ös¼[Éü*r©Í}ý¤¹mkiËì¯{»ól­¯¹xÒ÷Ëóz׿ˆ–‡ä™5´|› j_¼oá/‡ú5Å´:lju[MÖ[Öd†9®&HQ¤*¬Á8$…'À=+æ±µ,›?láŒ#©8ÅnìëCLÓ4ÝMÓômO¶°Ò, ŽÖÒÆÊ%†hQB¤qÆ *"¨(ó-ßV~㨤’²EêP@P@P@P@P@P@µ=3MÖ´íCGÖ4ûký"þ -®¬o"Y¡¹…Ô«Ç"0*ÈÊH*A ÛT)EI8É]3ù•ÓôãàøÛáãjŸÚáMrûE7þW“ö¯³Nðùž^æÙ»ËÎÝÍŒã'­}¦]_žgó/eWÅT‚Õ&ÿ톚·›kÍüB¾ž„ù ~šaý–(üñ߃¯~øëÅÞÔw¸Ðõ ­{‹f¶k¨•—8Œ’Udd‹É\H ŸÅs ,°x‰Ð—ÙmmkövóZ£ý<á þ—äø\Ö’­ÊÊJJ-¯zÊ×p•ã-M4Òz‘>q^l‘ö´j\Ó‰ëžHõ¨Ì¾Y4z0™j6¬äŽºr.)¬™Û Ô3¦,)¨gLYa[=ªYÑYSRÍ¢Ë(z†o]°}©E—c|*Y¢f½´K6Lß¶› óRh™¿mpAÐÑi]Œàíæ¤Ñ3¹Óï…ÐZgk¦_ëÍK)3ÐìoFš¨˜VGac{Ðæ¶R±çN“z•…îqÍmuz'ae{ÓšèŒ"µ¬´¿à|Õ¼dyuh­ÿšÖ2<ê´ ûkþŸ5j¦pÔ k­þ@ù«E3Ð/¥ÿÊ9«æ0t5/ýèçÕÈd¾ù¸4œ‹ 7ý~j—3zt Y¯³žk7#²L+«Ìæ²”ŽÚToc’½½ëÍa)½'1usÃsXÊG¥J™Ê^Üõæ°“=J4ÎFöã9®y3Ö£Láõ;Œnæ±lô"¬Ž Q¹ÈniŒóÝNbʦC8›ÙxcšgxùÜjŒÙÌÝ7=i£)“µZ1‘‘)«G<Št5hå™BZÒ'VfÌzÖñ<ÊîÆ§´X[*œ­Sø®›såQ‹O™µ;Øýiñ‰åÚà(½~áVµ‘þY`2ç6®Ï‹Þ$ŸSÖå‚9ŽÍĵò˜úÎs²? 8K.Ž ¥$cø&Ë$vÍg†‰ÙV>ŸðͨXÐãšö¨ÇCó<Ê­äÏqðü?*q^•$|N>z³Ù´H€ šï¦ÆI¶z¶‘Ñk²ÏWÜôa‡Ö¸ñ[C‘/yÉ¡¹_5‹?oáå{~°™²O÷kÍÃ?Þ3ís¸_½ž¼T‡÷¿}–èæÎ,…¤ÙòÅK?7EÖ î‚AÿŽš¬lo ü3W—Iù¯Ìý²¯ÈôX( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( €?+ÿl_ ËáïŠöÞ&D˜Øx¦Å%óe’2¿i· ˆŠ>eUˆ[1,ZC‚pBýŸâL;¤÷‹ü¿Ïæ2g…Íã˜E>ZÑWw_-’Ý.^G®í»>‹âÍd€ÐÌ?…ëÙ©ÜüÓ®œN»C›+×ÐÖô™äã¡©éZtœ/¥vAŸ9ˆ‰ØÙ¾q]g‘Z'Klü Õ}DnÀÙÅjŽ9è\¡’‡Ž”:š†tE“©¨gDr3Ò³’;iÈ»VMôähÂÝ+#Ó¡#J'éXI¥)šp?5„‘êО¦´RcÍ${j1IÒ±’=JU ¤Æ9¬eÒ¥VÅøå÷¬\OFbÒËïY¸qªXc½K‰ÓÖçqÖ§”¿n4ËO”‡X‰æ÷ªQ1©\§$ÝkUŠ­{”d›ƒÍj¢pT®fÍ/ZÞ1<ªÕŒÉeëÍožUj¦TÒu®ˆÄò+Õ3%zÞ(òªÌΕúÖÑG™Zft[¤y•&TsZ$qNEG5¢9*2»´rɱªF2dg¥Q“M²7<lKs6fç Þ(Êñš†tÁ³?^k6θ#åúšÍ”Ñu&¬¤ÎúQ9»©:óXÉž•(œÕäŸz²“=Q8ýBN¼×<ÙëЉÇ^ËÁæ¹äÏ^ŒN+P—–湦Ïf„?Õ§ûÃ5Ë6{øX;âK‘‰}«Ï¬Ï®Ë©ê4º“­~o‹¨ëbªN÷ÕÙù-àkpö9fGƒÃ(85N-§{©IsNéêŸ3w]6²JÇ#©ÊšÚ„O;5­ÊÖŸ€^_| ð=¬±Ù­î£lÚ¬òÙ®<ÿ´1–6àBС'8ò‚Bƒ_²d”>«–Ò‹Jís;uæÕ_ÎÖ_#üØñC5yïãëEÉœý”T¾Ï³JQWiEÍNJÖ¿5ÚM´s~<ÕUÏ4±S+#Ã6Ó7a_…W?jO k—:_Ú¼!à#ÿ ¡<†xãŽå(²F1æý§Ë™cvPém7Þ Tü¶aWF»Ÿ½p†¹ÆmiËñ×äÏé¼cô  € ( € ( € ( € ( € ( € ( Âø(/çð/í!c㸖çûÇú\S›‹‰âd7öj–ÓE.Q`,Kƒ–™ö±ÁT÷ršÖ\Êü|¿5-†â¤v¶7Ê@ù©©*I­ÇO½ãïV±‘çV¢uÖwý>jÞ2<º´žÒÿ§Í[ÆG™VÑÛßã5j¦yõ(–ú‡OšµR8ja͘¯òÍZ)’ ]þõ\Æ*ßú9‰t{îzÐä5DΞû9æ¥ÈÞL©¯xëY¹P¢b^^ðy¬å#¶N^êç¯5Œ¤zt©œõÝÏ Íc&z©êr·—=y¬e#Ô£Låo.@ Ía&zTác‚Õ.¹nj ŽúrwsT&púŒ¹ÝÍ2ÅÞÉÁ¦ˆg+týi™³œ¹nHªFR1§ïTŒdeK×hç‘FN†­³3å­bpÕ3¦èÕ¼O.¾Ìî~ Ý}“â¿…nÆÏµ~¶Óë_QÂï—3¤ÿÅÿ¤³ð©ûnÇÿ²ÿÓÔϬümã±°¹žILê}+ô¬N#–-³ø“%Êz±ŒQñ½Ä—Þ©%ãççcè?ɯŸmÔ•Ï×éÆ* šè{Oƒô¦T‘Á¯G ›â”Ùô& ƒêÒGÀcçvÏiГjÆ1^-ŽÇ;¶zÖüã9…ð‹ÐùûÅ1æWØ`%±üßÅ´[æ>\ñ嘞Úê"¹¤cð®ìDnš>_&«ìêFGé_ÀO·Œ¾|<×ešúk³§%ÕÆ¤Û渹·&Þi·1mòÂìœÀœ@ü›GØbjSóü¨ÿB8W1Y®K…Å]¶à“ow(û²{»Ý¦ï»ë©ëµÈ}P@P@P@P@P@P@P@P@P@P@P@P@Qñ§á…ůê^ŸäÕa&÷J§xR äÖ&¨lÆw²°*ß+’`¤v`qrÁVUVÛ?N§ÎñWQâl²¦¦’ø ïkM'ÊÞMlôz7ml×â/ˆ4ËÝ2ÿWÐuX®q-ÔÕü©£rŽ»”•8e# ‘Ç÷ÑœkAN.髟ÈÕ°µ²ÜTðÕãiÁ¸µ½švjëGòÐg‡nÏÈŽ~aòŸ¨­hÈáÌ)nÑëlÙÚ3]°gÊâ`v¶rt®˜³Æ­¨µ|Íl6¢7ퟭQÅ4iƒ‘Ṫ©íRZdªjY´Y:š†oZª;)ȹVM´ä^‰ë)#¾”ÍŸÞ±’=*S4¢“§5„¢z´jqIïXJ'«F©¥žõ„¢z”ª—ã—§5“‰èSª\I=ë'ºRâËŽõ›‰Û Ö%ÔòšªÂù¾ô¹JU€ÍïO”r»ÍïT¢sT®Ty½ëEŽ¥rœ“V±‰ÃV¹›4ýy­ãÌ­ˆ3e›­ožUjæl²õ­£Ì«T¡$žõ´byµj™ÒÉ[Emj…'jÕ#‚r*»V‰“‘Yš­#’r+±«9äÈÉÍZ2la=¨3l‰ŸìMˆdp¡±¥©•‡ Fö<[_¼ó&+ž&¼ Ûõ|<¤·z/Wþ[ü×|<È^q›Ñ§$œ ùçtšå‹Z4Úº“´^ÿìÒgw>澜êlf"É—Á_‡¿ðµ~&辺Mú ®u WæÇú$Ew'­ûÇhâÊËænÁ kê2 ·ûCrøV²ô_4õvZj¯~‡á.ñ£á‚¾6”­^»¥ÿ_$ŸÃ%îEJv’å—/-ï$~­ø£W ¿5~«^¥‘ü•á/%¡ñÿÄ-{ >$çžõàb꟮d µ¡ûÿáø=sðËöz°ñ>·klž&øpý®sØ ( € ( € ( € ( €>Mý¨l„²Î‹"ø³QþÒø‰ya%æà»ßiÔ°â5i$ Ém rß½—X¦òÖWŒÇYU­Jò;ð9u|Â|´–_cñ™à°µ>oü.϶—©ÿò}p¼{è‘õ1á8[Þ“ü?ÈrÿÁ`¿j#ÿ2/ÂÿüêüŸKëï².<#N_j_‡ùïÂø*ïí9à]n[Ÿ‰Ï¥üHðÜøó,/--´k›}© g¸µ…Qw;ÆÏæÃ6V «å–-Nž9·ïáxF7¤ìþóö›àwíåû2üz‚ÎüAµÐÅ­0 € ñ¿ôŸ u߇:íѱ’äÇsa¬Gmòéw‘¶èæ\¼Ž£4RHÓ~á¥*®ŒÔÑŘ`iæ8yaêlúö}ÿ®šÏÇïõŸ øƒTð·ˆíþÇâú}7P´óR_³ÜÃ#G*oBU°èÃ*H8à‘Í}¾_‰RJHþ\ã –T*T§%ª>îÑeÒ|cá=[ÃZì?jѵK9lo-¼ÆÎ‚T1È›”†\«• ŒðA¯¨å†*„©TW‹M?G£? uqYiKƒ—%ZsŒâ쥥fšvkfš}Qø‹ñÓölñ÷ÀËõǃUð†£+Åaâ9\DÌ Šu#0ÎcPû2ÊFíŽûoã¹¾K_+•ç¬ѯÉövÖßsvgúIá߉ùWÑåÃ^ž" 9S“WI¥yE¯Ž O—šÉíÍóFþ =+çåõúMä¬%Ó§P½9¬eÐ¥T½ÖM…:—.#Öm™e³hë§2ʵCGTdN­RÑÑ‘³PѼdYV©7‹,£ôõ©5L¿´š5LÓŠ^„“DÍH&äsRÍS: [Ç4‹Lé­.‡ÒhÑ3¦³¾(FŠLë¬u6ù~z Lí4ÝHŒ1~*Z)3¸°Õƒ†ü)§bg#¬³Ôú|ÿ­ki#©´Õ:|Õº‘æÔ¤™ÒÛjyšÑHà©@Ý·Ô†ÍZ©œu0æÜãæ­Î)áË‹©ïUs˜¼90ÔAþ*|ä¼8ó¨Œ}ê9ÉXs>mDsóT¹Ù“j#Ö³s:a‡2.oÇ'5G]:;uךÆR= TnïPàüÕ”¦z4¨µåøç欛¹Ù8œö cš†uCc†¿½ÜÍÍ ³¾»ni’Î.úë9Å6rw“ƒžj’!³š¹—9 Í³wÉ&­I™S?ZhÊLË•³š´sÉ”d=ªÑË6gÊzÖ±GY“¾×Däâ'dÏAø;a ž$½ñÄûcÑ¡ù#VÁ’YUÐdc•$Ï çoQšûÃ)W–!¿~.ëîµþv?›éý”>x$zM©éÂæ¿+Î?ߪ|¿$|ønïÂø?Iér>Н0û€ € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € üüý°¾G{i¬ükðÃÜZÚ8޵¦…’as ˆ\D%4 æËBÿ)V2}M˜ºmaªlö}¼¾}<ÿǼJàØâéÏ<Â){Hêù’²æ]œWÅÓ•_FŸ7æ}…ÊÃz[åsœzúˆJÒ?¯MΕŸC×ô˘Îx¯B ù,M=ÎúÎ^5Óx5¢uVRd[ÅžehÙt­S8gj&È«G3К† ’Þ‘¤Y2š†âË(jÕ ‘«6ޏH¹ÖrGm)—ãzÆHôiL¿•Œ‘èÒ¨iE'½a(ž­†„rÖN'£N±v9}뺕bêMŽõ›‰ßNµ‹j‡¢5Éþõ<¦ª¸¾½.B¾°5§÷ªä!â ï?½ZÍw_Ûb+|›³ü­øŸÕåK.ɧŽrÖ»Û¢Œ¢º-y¹¯«VåÙÜãï®p5ÅJÓæ®TÏÔ?ÙáØøðš?ê)·Ä0ê2|Ùòퟲ§ÊrŽÒäoßía”úÏ`>£UeñT³ù}ž¶Û^[=óׯž-|UÅRÀÑw¡ƒ½5çRëÚ½bš´’§kÊ?»æ‹´‹þ7×Råg¯zëÄÕ±óÙ.Í­5ø'ðoZý§>4è? tÉ<½25/^­Ê@özTrƳ¼E•³1ó8ÀFäRÀ v_šÆâ9Qû å¼Ò¶}:ŸÔíxë@P@P@P@PæÇíÅÿÑ¿fwƒáïÛM/ÄŸ'ò§¹²¿ß%–lØpׂ7Fi¥Cû¸UÕ‚°•È_-fæÄb¦çµ”äóÌ¥yiýý?¯øÎ‹ü]â߉^.×¼{ãÍzëZñ†·pnoµ+Â Ìø ˆªDUU ªðkW”ÛmŸ«å¹e<4)ÆÉ¢ÔÕÏíeaèL-{RêG»®-20E\*Øœô±‡>œ¼üµ× ÌùüFZ»N~Î_¶ÆÏÙ—Äþ¾ð÷Š5]gáî›æAqà SQ™´Ë‹idó&Xb%’Úbäȳƛƒ’X:<‘¿mKOW¡ó–IN¤JÒîU>7ü<ý¡>hÿ>ëmÐosÖó—ZeÒ€dµºˆåÌ›—#%YY]ÑÑÛÔŒ”ÕÑð•¨Ï7N¢³=n¨È( Åø(¿Ãh¼ñWÂ?4‹{‘gã8Mެë­ Wö©Âí1bŠó[a ©Å“¸ÜK‘íå8‡é³òÿr…V1ÅÅo£ùm÷¯Èó?…þ.Gm'8Á¯¸Á׺±ü¯Ä¹S„›H÷oxCIø½ðÛÅŸu©ü«-rÌ—8fû,êDMµ] ùs$rlÜlÚx&¯1ÁC… }¯Ï£é³Ôæàî'ÄðƆÍ(-h´ÚÑ^;N7jVæ‹q½›WºÕ#ùÙÕôSÃ:Þ³á­rÛìÚÖ“w5å·˜²y3Äå$]ÊJ¶HÊ’8&¿ÄP ’§5iE´ýQþ å¦3ÂQÆá¥ÍJ¬c8½Uã$švi5tÓ³I÷½³\®'¿N±z)3XÊ'¡F©¡+Dô©U.¤™¬š;áP·ÖrGe)—³Y´vÂdÁª7Œ‹(Ýê:¡"Ú·½KFñ‘:¶~µ&ªE¨ß‘ëRmhE6:RhÕ3B)±‚ I¢f½½Æ0sRh™»mv29¤h™½m}ócu&ŠLém/qƒº‘¢gSi©”â‚“:ý7S ¯ÍÁ¤Rggiª}ßš­;µ"ätöº§æ«R9§JÈêm5<ªüÕJFS¡to[ê}>jÑLäžÛƒSà|Ý}êÔÎia‹Ë©ö OœÉá‰×T£UsðÃÛRù~õä¬6¦|Ú—_š¡Ìè†Ï}C9ùªyÍã‡2çÔ2樔Κt ›üçæ¬œŽútlsw×øSóVmÜê„9QÊ]꺓5G%}|H<ÐmåÿÌFi’ÙÌ^Þg#4ÙË]Üg<ÓD6sWSõæ™ ˜3ÉÖš3lÇ™úÕI™’·_j£3>CVŽy²Œ‡­hŽI³>SÁ­b>´Œ{§À5ÓM.vLõŸ G.•ák{hå%¯ÞHCdê à ¦zóœb¿GÊh¼61¾²÷¾ÿøùÜþ-ñ2ŽwÄ•ê¸ÙQýÒïî7võ{ÍÊÖ·»k«Ü³m¦5Äêμ“šïŒ.õ>V¦%S‹Hôm/Lå^uÂÏbq;£Ö´›\,C+ºœO”ÅUÕžµ¢[ðœW}4|¦6¦ç­èðŽ+ºš>W;ÜôÝ-@ uÅŸ=^-»þœ>íj™Ã(ž¡&Y~µçâÞ‡Øpõ;Éçáèñåñ_'–çô Ò·)»®ôv®L'Ä}~ÿrϟ뇲jù¶.ž —<Þ—vJÊí¿$“n×zh›²<Æúïï×ÂkZ¤ªKvÛûÏëéåøZxJM¸ÓŒb¯½¢¬¯kk¦º#èŸÙ‡àT¿uÄñ׈Zð|ªöî±ÊÚ¥Ò“ìí 2 ™[b‚K4iÃY×f±5‡¶™­mnÝï¾Ë«_Ìž7ø©þ«áe’à.ñ¸ˆ;I^*”%xó©+>{¦©¨¿u®yh£þ†xëċ̞½ëôMkÇù\äÖ‡Åþ-Öµ-kT¶Ñ4k;›ýbþtµ´°²‰¦šêg`©q¨,îÌ@ $|Þ/kŸµðþPåÊ’Ôþˆÿd?Ù–Ãödøm6u¨[j¾;×.P×µ‹xUæØ-¡r¢F·„nÙærZId ˜c_—­UÖ•ÏÝò̾9uMjú¿ë¡õebz!@P@P@P@ùYÿ4ý¯õo‚>Ó~ü0×®´¿‹^+nîµ+kv¤èÌf‰¤‚ãpÜË,F4dȉ3~éü‡<¸ªþÊ6[³ÞȲ§˜Uçš÷âÏç ÊÁQT*àWV³lýk—FœRŠ:;kAÇÅ:‡ÓaphÐ[_ök.sÑXTº-¦{~•<æ±ÃvBMeíN5 «„MleMd9ùkxÔ<ºØ$úWp*~ZÞ¬Ï#–)Gc¢øeñCâgÀ¯Åãï„Þ,ºð÷Š£·–ÐÝÛ$s$ÐHø¥†UhåBB°WVÑȬ=8—™ñ™žI ©©FçígÀÿø,o„õ{M#öˆøw¡ë/q'Ä^ŒÝiåW,Ö²ÉçÀ‘FaÈ®^LHUWåCéÃ|GÄb²*Ô›tõ^{ÿ_qûK¥jº^»¥éºæ‡©Zê:.£oÝž¡c2ÏÜ(t’9•te!• ‚®£Ãi§f_ G“|nøA៎_ üCðûĶöÙ»…äÓµ)à3>‘~„qÈÛãfÉPë½KÆÇc°:R©*RS‰ÉŽÁÒÇЕ ªéþ£ùÏ}Îâσ?üAðÏÆÂÚ/h ȳœM Šè²Ç$mÁ)$RFà0VÀeVGØ`1ŠqRGó‡ðÔ°µgFkcë¯øÆå<Ì~†¾§ ]OCð<ç+©…“’<óöšý—¼;ñ›Ã:÷‹¼# ÁÆxá…­oRèÛ.¨±'1³4Dª;mÉ ´‹‘^?pý,Ê”«Qïô³½¯n¦Û=‰7cô<^ÇðNaC-Ìk·•·.h¸ó:n_ni%+9E6­)Ê0ugâ͵ö™{y¥ê–sÙêvr½½Í¥Ôm¶ò¡*èèÀe`AdA¯ÈêÒ•98MY­ì¢x}eb0óS§4¥&ši«¦šÑ¦µMhÑ7®§£éÃ+ò×]8Ÿ;‹¨õ=KF·i»©£æ1•7=3L…†ÚêŠgÏVœOAÓ"o–·Šg™Zq=N‰ÀRkeu¹æÍÆNÑ=?@EÊ|§5åã>ë‡)ÆëCܼ? qÒ¾W#÷þ§d™g\•D g…¼uçõR¢Ó<ÄŽŸ¼¯­Á'¡üñŇ¼|÷â—M’W«Wcà°)¹«QþÅŒðãÆ%ñ=À?_²ÚWæœGþö¿Â¿6ox0šáÙßþ~ËÿHö x'ëA@P@P@P@P@P@P@P@P@P@P@P@P@ÿ´ïÃI~üVºÖ ºžãAñœ·:¼ÜÝ É—uÌiÉUicub«òÌæ(Ì~Û#Æ{z>Íï/—F0x¥ÃO+Ì^. ¸Wr–¶ÒW¼£è®švZ;jÓgšh÷A€\×ÒS‘ø–.•µ;‹9ù×LYâÖ†‡Um(À5ºg—R:›vòôæ´‹9*DÚ‰ò*ÑË%bÅ I’HÕ2Ej–c"š†ŽˆÈ°­PÑÓ £jÍ£²œËi&+6ŽÈT±m$÷¬ÜNÊuKi/©¬ÜNÚuKI5fâu¹ae÷¨q:cXœMŽõ<¦ê½‡yÞô¹Köáç{ÑÊ/l0ÏïMD™W y½ê”Ny×+´Þõj'4ë•^jÑDär«ËZ(œ“¬Uy}ëEŽ¥R«Iך´ŽIT¹]ž­#šs+3æ´HåœÈYª’0”ˆYª’1”ˆÉÅQ“dlÔr-ô ¢´Òõ¡²£.YyëPÙјóÏך†Î¨@ƸŸ¯5›ge87y¬›;éÓ0î®p5”™ÛJ™ÌÝÝuæ²”J•#•¼ºëÍa)¥G'{wךÂR=Z4NBþô ó\ò‘ëP¢q:…îsÍsNGµ‡¢pz•îs\Ó‘îa¨ži­j[þjã©3é0xnfÕõ,Ž3À5ñ™®)âk{%ðÇñ}~í—Ϲý1À92\¹cªºO§» â“W~ò´¥ªû)¤ãªøÀ~,ø­â«/x6Ãí:¥Æ^Id%a³„yœ²5ÈÉÁ$•U ̪o,Ëkf• íýÉw~_ðËV‘ËÇi–ð~[S4Í*rÓŽ‰-e9;ÚZ^NÎËD’r“QR’ý›Óô|.ð^‘ào ‰“EÒ¡hâk™L’HÌÌîîßÞgwc€Â…û *²üÈÿ‚w~Ê~3×´Ú‹Ç’[ i÷·…ôb±\Bæ6’¼œ0aC*¿”££e4ó¾Wˆæný÷†²eFÄOä¿_—N·××÷¼ãì‚€ ( € ( € ( € (Â?i/žýš¾x“⯉m¾Ül¼»m;EŽê+yukÙ[lPFÎÞ‘Ê«²E®öm1R¢§&u`ð³ÆÖuüü†ø¯Æ/ø—âÝ{Ǿ=×®µ¿ks››íNð‚ó>¢*…D@DEUPª ¯YͶÏÙ2œºjq§dˆí àq^tæ}ŽoÛÛð8®YJç½F…‘« ¡“-fävFŠfÄ;¶8ý*ãE!×+€p)©è£}5ÐüËÅZ™Ë<2} Ë‹”ñZFgl*jÖ9«»O×N­ÅåüÛýΟÃ`Wd+9ŠËwÐû×ö1ÿ‚ƒxËöT†Ox¯HºñwÁ«‹…–-1.Dw~w”å², º2´ŽmX¢4¸e’"Ò™=l>&ÊÏcóìã%ç“©OI~×súpð<ñ?Áþñ÷€|Ak­øC[·6:•™;&LAGV èêÊÁYHŠi«£ãg S“Œ•š:êdŸþÚ¿²üÿ|gâ?XéÑü_ðéßgqp<§Õ¬€rú{K¸*åØIH «†\ƳI ëÂb^zì|ÿä°Î0öŠ^Ñlûù_…ÙøÇð¯ÇbIaQ>AŒ_ÿU}žw¹üÍÅ,[±úàAwm rÈ à`æ¾¢e8ÙŸ…fY}L5W8­0øõû|;ý¡/Å)ª\xcâ… mfž+ÕV@¦êÜ•óYcVDut`CXÑÍç\;C1—µ¿,û®¾«®š-Wì‘ûO†>2f¼A`Ul-Ûä“iÅ´ïÉ-yS“R’q’½ÜT\¥'øsñ À~$øUã|=ñlvéâ aÆÒQ,R«"Ɉܯ£À0 †U`T~]ŽÁTÀו ¿áÓù¯ø'÷‡ ñ6Šrº¶·Jªºº³M7&»ÆI§fÓjñmY¾r)}ëÏ”O±¥X¿ÞõŒ¢z4«šKžõŒ¢zTk\¼’{ÖMôêÒJÉÄí§T¶Y´vBe…z†Ž˜Ì°RÑÓ –QóPѼdYWõüêMT‹ ø¤Ñª‘r)zsScU"ürÔØÕH¿ü€M&‹LׂçÅ#DÍ»k¼ãšE&mA{´õâ“E¦oZÞç5"“:[}HFÍAW7­µ~˜oÖ‚®o[jäcçýiXw7 ×và¥b®jǬä»­Z]g¾ê.M“ý·“‚ÆÅÊFú¿ûT\iX¥6µ€~zV)3*]\89j,+˜·:ž2wS°®s·:žOÞ¦+˜w7ùÏ4s¹½'<ÐKf÷}y§b[0nnÏ4ÉlÆšrs“A ™’ËœÕ$fÙ›4‡ 4Ñ›ft֬ɲ”TŒdÊ27j´ŽYÈ¥+V‘GYSÉŒ×Däb*Zç |,ÑÚö÷V×&Œ›{DD^,ƒ#òJ¿fU s‰;gŸ³á|'4爒Ñ+-:½ìû¥ø3ù—Ç^!öX|6OJ^õI9É)kË"¥±”Óz^ž‰µ§©}˜É3w¯¯å»?½§,N—OµÚb¶„O6½[öiÈb+ªœO W¡èÚ]¿Ì¼W\󸪚¥£[ýÞ+¶š>cPôý*Ø™Ù|Ö*¡èÚeª€§×Tb’¹âU«'+#³³‹¥DÙÓ‡§sÒ|=)Åx¸É¥ðÝ Qì}ÜV±ÈÝŠùºÔÝGsöÌ·O MFú™šåà0–ƒ]JV‘äq5J“ižâ ÆAž+êðpµçþ#Ŷñ\ØŠn{é¬ô<\º7š>Ûý‘t}/Nø)¤jz}¯•w­ê××Òovóç[‡¶ ‚H_Ý[B¸\“8É$þ[ÍË;ô·äyxa‡…¸+9s7æùšü’_#éºò¿ ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € óŒ->*|<ñ„%®¡4~~s0[^'Íî(ÅŸ‘ÊÞ[¸k«‰xJñª¶ëé×þ‰²:|C•ÕÀÊÜÍ^-ôšÖ.öv]$Ò¿+in~.i’ÝØ]Üiú´Öº¬ö×(c’•du<« Œ‚+ôzÒ”]Ó?‹s<èT•*‘q’m4Õškt×F»‡es¸#]Ñ‘òõ©ÛC°´¸È5¼YäU¦oÛKÈ­S8jDÝ‚nœÖ‰œs‰¨¸Uîc¶„€â¤i½‘dÊÕ ÆDÊÕ-ÆE•zÍ£ª,,•-¨YI+6Žªu +'½C‰×¤é'½C‰Ñ ¥•–¡ÄêbA7½O)¢®8MïK”¥\ ÞôùA×f÷§ÊC®BÓ{Õ(˜J±KV¢sʱY¥«Q9§T®ò{Õ¨œ³ªWgÍZG4ê™ñV‘Ë)‘3æ©#Nä%ª’1r"-ùÕ$e)“­Q“c(!²»·&¤Vy1ÍZætÒç<Ô¶o3ÏÁÖm0…ÌYçëÍfÙÙNÌýy¬Û;iÀÀ¹¸óY6wÓ¦sww]y¬e#Ñ¥Hæ/.ºóXÊG§J‘Ê^Ýõæ°”R#¾¼ûÜ×<¤{)uýïÞù«žR=zN'Q½Æîkžr=¬=€ÕoðÝ\“‘ïah\òk ¥•\y‡ ëø×‰™c}„9`ý÷·ùÿ—ŸÌýO‚¸aæØ…Wöx|Nö»¶‘O¾ÜÖµ£Õ7æxÀ^-øµâÛø*Ãí:­Î^I¤%`²€yܲ5ÈÉÁ$•U ̪|L³+¯˜×T(FíýÉw}—ü2»²?MãŽ:Êø7,©šf•9iÇD–²œí+«ÉÙÙ]$“”šŠ”—ì‚¾ø;ö|ða𿆈¸ÕnËªë“ Yõ9€<‘“²5ËŒË3;·ë¸ —ìhêßÅ.­þ‰t]=[oüìâŽ.ͼLÍÿ´³vœn©RNñ§ÑmÍ)Y9ͤäÒÒ1Œ#ñ÷ÄS?ÌsÞ¸ñX«&}C9Iho~Ç?³lÿµWÄ‹ígÆ–Zš|ðáߨ]Ûþê=Zð)§¬Ûƒ.äc$­fTsMƒå±¸·²Üýë…øzJ¢÷Wâû_…Ñýéšf›¢éº~£iöÖE„ÚÚXÙD°Ãm (TŽ8ÔDU¼fï«?JŒTRIY"õ ( € ( € ( € ( åKþ ûK\þÑ¿u3FÔ-n~x{+Ãk,.ØùkwyçÆî&I¥€yL'“$"»H[ÇÆ×æ|«d~Ã9S£VkÞ—áØøÚÊÛÅxµf~ÃhŽžÖ×8⸥#é(R±ÒXØ<̨«XJG«J™ÞéÞ»“iT³r:ãLî4ÿ_6Õò3žØ©¹²¦kÝø R Ÿ²ñì(æ)Ò9;ßÞáƒ@GÔSæ!Ñ8O·ֈYà;=EZ™ÍStp—šc©9NkhÔ<êØKœåΞÃ%èû¥Ô|wx.d[]ûRêÞm‰çÂw"¹­Œ”‰åôéÕU‡Äcp50R´µ]ϵ+Cˆüœýºe-/I´ñí'ðÆÐÙê–Œ/AÇ~•öXlUÒ³?š3ÌBRŒ‘ö·ƒ~Ñv6·Ì×_Œ4Ø^+iʆTVVÛêÃ÷Ð >Ì«»c¦÷ÝäæÙ67ŠU4šÚKò}Õõ·ÜÕÙú‡þ%gÕ”°¶©‡¨Ó)_•´Õå¾ ¸®^k4Õ¹£.XÛñ#ãÀ?‰ßµaaãm~•'”-üC¦,“i×NêÌ#IÙ.@cp¯ò¡V?˜æy.+,•«GÝé%~Wóï¾^»jsð?‰™Pö™mkUW½)¸ª±I¥Ì⛼]ãiE¸ê“jI¥äQMÓšñ¥ôªUÍ8¦èsXJ'©F±£ÙïXÊ'§JµË±ÉïY8ôê—’NœÖMôêUë6Ž¸Ì°PÑÓ –•ê:£2u“Ö¥£e"¹©hÖ2,$˜éRѲ‘m&¤h¤\Žn•-©â¸#½#E#R ¼w©±Išñ]ôæ‘jFœ7ÛÃP]Í8õ'8敊Lݵ¿n>jE&nC©š‚®jC©ž>jsZWÔåÁªñ÷éáý¨?¿@® ªd}ús>ãSÏñŞÔ?5¹B}E˜š\ÄŸP òh%³*âÿÐÑa\Çšó9æªÄ¶d\]õÁæ‚[2%›$’h!³>YsÞ©"(I/çLͲŒTˆl¥#vªHÆL¨íÔÕ# 2“·SZ#–r(JÝkX£Ï«3ê\溩Äð1•l™õw„´ˆ´/èzd‹²öH¾Ór)Ä’|Å\uÜ „Éç:tªå˜e„ÁÓ¤Ö¶»ÒÎï]|Öß#ø Žs¹ñc1Ñw¦¥É{š<°÷S‹Û–m9Ùiy=^ï~;HæVÉ®þT••Y=·al¹Ö‘G"£;ý.Û€uB'ƒŠ¨z.—g÷x®¸DùìU]ÏNÒ-¶…â»i£æ±u.z>šŠ›x®¨è|ý{Èî¬îÖéžeH4îŽÖÄÇ­aSCÕÁ5Q#¼Ó®Eº(O½ë^Uhs½O¿Ë1K £¹ÑÁz팹®)ÒK¡ôØ|t§»R°òsJ„=ò³\K–$y.´~ÿã_E†?ÎÝÛ>~ñ„ÛbŸ,ëEw£W Î'èGì¯gyeðÀPßZÍo3­äê“¡Fh伞HÜÕYYOB¬È"¿,ͤ¥¨Ó¾ß’?½|<¥:<5ƒH´í'ª¶Žriú4Ó]ÓLú¼ãì€ ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € üËýµþø£Eø­§G?\Ù§j_7Ý»?tü¹'|1•¨Uû>IÌ•õy2ñxytÕzuûŸçä~âïrW†oIiSÝŸø’÷^¯¬U´I.K½d|¹¥^‚«ódúØHþxÅQ³;›+œíÁ®˜³Ä­Lê-gÈó[¦y•aczÞl÷­8§nÞaÐÖ‰œ“‰ j·2*KLx4)«T4k«T´o“+Ô´o“¬˜éPâtF¥‰ÖJ‡¢5IÖ\w©q7RQ5O)²¬Q{q¦oz|¤:äFSO”ÊUˆš_z¥U!ijÔL%TžªÆ¨DÏUcT!fªHÂS"-T‘“‘oJ¤ŒÜ†Šfm‘î´Ƴ5]Q–@;ÔšEòÍïRÙ´bdÏ?^k6Ψ@ʏ#5›g]:f$÷žk6ÎØS0®®@šÎLî¥Læ®îÀ Íc)W9{«ÁÏ5„¤z”¨œµíèóXÊG§F‰Çßßõæ¹å#סBç÷¹®yHö(P8Ëûÿ½ÍsÊG³BÃjZ‡Þù¸®YÌöðØsË|A­¤ #¼˜8ê}…yø¬LhÅÎlû%¯™×Ž¿Á.­¾‰ÀWm!¿þøÓö‚ñŸü#þfÒ­¶Ëªë³FZ *N äl0Ž Ar %U]×ÇËrÌN{‰²Û«éýlºýìý¸ã$ð«$R’¼ÝÕ:iûõgevÝ´KNyÚÑVI6áûWá ø+àσ,|à›1k¤ÚåäšR{éÈçÀäl œUPªª£õŒ&†YAaðêÑ_{}ßwÿ ¬¬óç?Ï3n8Íjfù´ùêËD–‘„VЂ»´UÝ–­¶å&äå'óſųmŸ¶5çcñ)m™,¤•ÑÎþÍ?³7ŒÿkÎòÏu£ü"Ñç ­ø’5¥lûžàUîJ’ĉX;‚Z8åù&üzø9ðn ¤ø—ñFÑ.£‚;‘¦M?},2HbY"³Œ4ò!pÃr!c“€¬EBœê|*æ8Œn¯Zj?ŸÝ¹ñïˆÿà¨ÿ³n‡¬^iºv•ã~Æ›5}'I†;{œ¢±Ø·3Ã(ÚIS¾5åN20ÇuƒªÕÞ‡“>$ÀÆN1n^i/Õ§ø7„à¥?²·‰tÙïµoëÞ¹Žvˆiúî‡s,Ò U>j›1qÂX¨Ãe*ÒSÂU[+šÓâ •å>_UþW=£á÷í{û5üPÔ[GðÅÝMXÏ´6Z¨›Jšòi˜¬qÛ¥ÚDÓ¹eÆØƒYAÆåÎr£R´uÐÍ0x—ËN¢¿Ý¿kÚÿ#é Èï ( € ( € ( „¿à¡¿´aýŸgÍm4Sì¿|g¿BÐ|‰ü»‹]ëþ“z›eŽTò!'lÑîòç–ÛpÃVŠžÎ õ=L£õÜTb׺µåóü®,Zu¶x¯›­=OÚòÌ-’; 8>ïçNGÙáhYvdÓ0DRkšR=ª4\ð熙Ú=ÉÔúV-žŒ!cè]Â$ÇîÿJ›©$^Ñ|¿ºçé[B“{ž~'©è™Õ]x?÷@ù]}«_`yÿÚžg#qàfÏîNߥÀO5ó9/ü7Ýl@·ëíWì ^i®çƒkÿ |°äÀAö2¥Ë©­<ÁÕvG“^ø!ÓÍ3Ækk3Ñ•%(Þǘk>žØ¹ØJjê§Q£ÄÅàã>‡s§dœ-v½˜Åe—è;ž*ñ‡Âÿè>?ð¿u¢xÇD¸6:™á|Ate,ŽŒÊÁ•ˆ>ŽÖ¨øÌß(Œ“ŒÖ‡ôyûÿÁG¼#ûB@þø¿>àߌip±Ú@“]?ÄI,¡!K#4ŒÂä4‘Æm‹³¾CÆXb•eQk¹ù¶?,©„•â¯ËÔý=­Ï0ü;ý¶?fË_€ºõ—Åï…ºÔ u›†MoL³…M§‡.ÙFÑàîŽÞvv »|¸¤P€–—ÛËqÎ/’lü»8VhU™@çÔŠúº›´~šä®“hû[ÁZçÛLÊ_;ºW±Aó6~s›Sö‰Ñø§Âžñ߇u ø·HƒSðêÊä².A‚¬¬+© ¬¡”‚b0ô±4¥F´y¢÷_×çºzœ9>mŽÉqÔ³,º«¥^›¼d·Oòi«¦šjI¸´Óhütý¤¿a½[á&‡yãφúµÿˆ¼góßé÷‘)¾Ò๜º³ÆH\ª!J’CÈ¿›g\+,7ˆÂ·8-ÓÝ.ún»è¬»«µý³á—”x› £=§™é Å¿gRM»BÒ»„­eÊJrºN2p„¾ †~œ×ÅÊôÕ A§Ý9¬%Õ£\ÑŠnœÖ‰éÒ®_Ž^œÖN'£N±v9A¬œNúuKHõ›G\*ê:¡P°¯PÑÑ……|{Ô´o«ûÔ´m¬•-ÆE””ñÍKFªE´—Þ“FŠEÈç#Ò±¢‘~;¢:E©â»éÍM‹R4b»#Ò-3VDŒ`Ð4Í8uãšV)3J-K§4¬UËéªïP;–WS>´äŸÚGûÆ€¸Ó©ŸïP+¾¥‘ŒÐ+”¤¿ÿj‹ åuzv̹ï sšvÌén½è%³6[’{ÐKe 'Í;ÙEæ'½Uˆl§$½…!²›¿Z«ÙUßó¦dÙQÚ¨ÊR*ÈݪÒ9ç"”Ö´Hã©#6y¶„O/U$KáÍ6ÛXÕâMAKépׯ±œáAòG8ÇÁô96bë'Q{‘ßô_×N·±ø÷‰|Y>Ëe $­‰«u .•­Í'ÓDô½ï&½×+}'.¦n%ó7pÜ×èŽwgñ´pÊœlnرxÃçŠÖ;5ÕŽ·NB̼'ìLҠ "»)£æñU.ÙéL+ÅvA;‹™ê]¾q]GÌâjnw¶ÙÛÇ5Ò£sÆ©VÇcelWi«Qhå•XËC´Ó£ÆÜ×=f{Ym+Y½´cjœ•åMê}îšåNƪmw5s»ÉØö!ËM]˜z­ùÚÛHÈè=k«G¹àæÙ“åèy^½¨ªÅ#îãÞ½šqöqÔüÛ_ëuR‰àÍ£j¿¼aáßhsˆµ-zì[ Œ+}š Í6ÖtåÄ’>ÍÀ¶Ý£’+ÇÍ1‹ BUCônáÉç™ ~ÓÕö[·­¶I»uµ‘û5eeg¦ÙÚiÚu¤6º}¬K Öшã†5UF¨ ü¾Rrm·vÏîêtáF§N*1ŠI$¬’[$º%ÑiP@P@P@P@P@P@P@P@P@P@P@P@P5ã/ é:ð®¿àýz"úV­jöÒ•Tg‹pùdz²‰¶º1Sµ•N8­(Õ• Ф7Gc€¡šaj`ñ ðšií÷«¦®ž©ÛF“?õß x³á—‰5xÒÀÚë6D2:ÐÞ@IÙ4@ß`ààAV êÊ?CÀâኦ§ýv?Žx«‡qY6X\Tl÷O£]}SüîšhßÒïDŠyêÂW> G•}­Ï#šÞ2<š´ÎžÚn‡5²g›R6 Ÿ‘Íh™É8JO5¢g$ãbÎîhd’ùR)1àúPZdŠÕ-ÆDÁªZ6Œ‰CTØÚ3%RÑ´fJ¥£UPxÒ±¢¨µD9 'Òƒ6ÈØ€iˆªÒ`óH»\‚Y°841¹›4Þõ ›Â\÷y¨lé…;˜—y¬Û;)Ó0®nºóY9ÔéwxšÍÈí§Hç//:óXÊG£J‰ÊÞÞuæ±”N–¼¾Æîk Hõ)P¹Èß_õæ¹å#Ö¡@ão¯óŸš°”b… mýÿ_š¹å#Ø¡@â5C¾jæœÏk‡<óXÕ–5r\$“€+Ž¥D•Ùô8,ªIF*íè’êzgÀoÙgÇß´.¥¦x—T†ãCø0'”OâȲߘ+Çi|ÌìIA)S“—t176 *ÄguT¥îÐO~ö컾ö²×v¬ýÞ&ãܣà ¾¦…ªærŠ÷:C™]sµ¢ŒwqR矺ôŒ”£úˆÖ~ø)áÕð_ÃßEÐc–K†‚yY\üÏ$ŽÌò6®]‰ ª£ ªßÓ¥C,¤¨aãËþ~¯Wóô?‘1xüÛŽs f™ÅgV«J)»$¢¶QŒRŒVîÉ$Ûrz¶ßÌ~;ø¸!K†7Œàg­yÕñ¶GØeévHÉ*Ã,¢Gg‘$'<0ÀV«+ÌúŒOeØ ^ϯmEëÝþ ÷>JñŸí7ûXü]¹s¨|D¾ðÖŽÓÅq“à€ÚB@É–@¸Bn,ì’N˹²Ú}JLz«Ÿ šø‡YÝBj+ËOÇsÆtÿ…ÑiñÅ6 ¥?Ùç>¹¯Z% ?=Äq4«É¹N÷7âøv’äI`»©(3ùÖ« }ÑÁ. pøgø–¿áXXE–± »°þ¥ÐÏýe«&—9æ~'øZJHööüz¨é\u°]‘ô™gÙ¥9¢ÿ³·üCSðN•¡øöˆÒõ=RÖÓÑxö;Ñr"ß§Û  4¾ZYî#f•‚ 1I!içñ9t¢Ü¡÷¯ä¼gB´#Kõþoó_®þMê~Æéº–¬éÖ¾‘m}¤ßB—6·¶r¬ÐÜÂê$Ô•de †‚"¼¦­£>ú2SJQwL»@€ ( € ( €?–ø)/Ækϋߵ'ŠôM_í^ øÿæ›o¸Š8îcÁ¿vŽS·Îû_™ HŠªñÚÁ÷‚‡oVòåì~¹-U­e¯Ë¡ñ}„ŠðªÌýc/ÃÙ+e•³;ªOÐW™ôô)žŸá‹(3ƒØŠÂLôéÀú—Â^Žq *zqŠÍ‘–§Ò¾Ðá ˜ÇÑNÜò1¸žDÔOmм9náp¿¥z4©£ã1ØÙ&vßð†,ñ Ú:t®¥Dð§™´Þ¦n³áÍÃ:]ηâ=RÃJÑ­¶ù×ú•ÄvðC¹‚.é…\³*ŒžI½\pқ劻91å,57V¼Ôb·m¤—M[Ósæßü}ý›íç¼Ó_âRÝZÊð»Zé—×3)*JJ”uÈáÑŠ‘‚ íY6)«ªŠÿ3ægâFCN£„±KGge&´ìÔZ~©Ùž!âߌ¿ZÊæëIÖîõI×lìô˘ä“$”Ì‘§’rÀq“€ry:¬¹y,»¶­ø]þ|<[á\¾“ªñ.¤•½ØÂ\Ï^œÊ1Ó}d´Z]Ù¨|OðeÑ‘áðþ¼ª{=¼ÿjÔ>Ç·~hýïÿ‘:aô†áHǕѯðÓÿå§kž ð¦£j$ŽK‹y_9·¸¶}éÉ• ¼õàž¿…sχ³RqPæ]ÓVüZìa|càÌuÖž)Ó“¿»*srZÛ^HÎ:î­'£ÖÎéxö£iòðJr0{QÚ¹¾¡„œ]iäßã±í¾-áœM(Õ§™Q´’jõa®ºÆMI>é¤ÓѤÎRöÌHÀ"šs£.Y¦šèôfu!†Ìè*øYÆ¥9^Ò‹R‹³³³WNÍ5êŽ2ûNå†Úô)VØøüÃ,ÝXû[öwý¼~?|º°ÑÓâΣáøa‚Æ×HñY“QÓ’¢–8£;¤lˆ<}¢ËO3r®+è°xª5ÿw_GÑÿŸá­½{ŸŽqE˜å-ã2¤çw*mßµ•5k÷n<Ý”SÒ'íÿÃßø('À?‰zTþø½¥?‚õ-L6çJñ'RÒï’w’"†écÙåy{<Ós(¢R2ê¬Ã¶¶µ¢¹óåÙ”9g.Vô³Õkçµ»ÞÇä'ÄÛ? øCâŸn>­ä¿ìõ–¶Ón®.RìDŠÁII‘˜=«Jȳ3DbÞw·<™/`±˜ùe®v«»M-ù|×UÛU¥íù_Ç.Äã«àð’÷µ²ïe¯+ëo¾Úë­¾¨ð"û4SA8`ü†¿PÃÖVº?ÎrÙ{GŠÖ>˜ðÿŠc»DY\ë^Œ%͹ñ˜ª_WwŠ;6¹Y@ÛŒc­j¡c‚¦%OCó?ã×ì¡ëg_ñÁ‹¿ì½vO2ïþ)•ÊæC°ùV¯òý›8”…mñîuQä ãâ³~§_š¶ òË~^É?³×{«éî£ú{ÿ¤f3*ögCÚÐV·Wö‘ZûÕ¾ÖÞên<³åNOÚÍÙþZx·Áþ/ø{®Oá¿øvûEÖáÜ~Í}O5²y‘·Ý’2ÈádBÈÛN ¯Ï1˜ø*Ž–"2óû®»­7ZÙ;ÅY_a#ŽÊ11­IÛX»Ù´¥Ë%¼d“WŒ’”oªLȆã=ù® @úÚ8›š‘MžõÏ(µ÷/¤¾†±q=u‹±ËšÊQ;©V¹m³hí…B½CGLjýê:aP°¯ïÍCGDfN¯JƪDÊø©hÖ3,$”¬j¤ZI*lZ‘a%ÇzV5R-¤Þõ6-H»ÁéXµ"ìw>ô¬Z‘~;²;Ò)H¾—œh1ao?Ú ®bÊ^ŸïP&7¼}ê,;‘µéþõ ‘›Ïzr´—£ûÔ ˜¤÷y W*=É=èe).=騖ÊRLOzv!²³L=i“r³ËšiÙU¤ôª!²³ÉÖ„ŒÜŠìÕFR‘YÞ©# H¨ïV‘Í9”f“­myõª"¶»Õ/ì´½>/6þòd·‚-ÁwÈìFId‘É8®Ü5 שPW”šKÕŸ/žf´2¼ln*\´©FS“³vŒSrvI·d›²MöGÒ^.ø1¬x@ðÝî‘gs{‘ÿ‰­•§X'sM؈¶îPv¨Q,w7?¨C'–[‡„i«ÿ5µ×«ôè´Z-ugðž#ÄŠ\kœâªâæ ¯j)Ú-Ó½£ Ús¿½/zMÊo•rÅ%ƒ¦Ì÷³FˆO=M\39qTbÛ=:Ò=¡#QÒ»bš«+·&wº=·+‘]4Ñáb꟦AÊàWló8š‡¥iøÛÅvSGÎbê¥ÁÂq]°GÍbg¹ßXBÑcÆ©&΢ØghÅ9=§ NºÁ~ípÕgÕåÐØì¢eŽ%f=«Ì’rvGÜÑ”iSR‘BîürV´èžv31µìÎ7RÔ0æ¯J+™cÜ´LñÏê¦8ˆÝƒZÖ•‘ÖPu*s3Ôc/AâxÇâ~¥aæÅ¢…Ò4›‰ .‰s"ïºeR ‰*ÄÐ pT¸•~l¿Ę·)F„_›ý?_¸þºðW *U³J‘×á‹ÓÖ^iÛ–ÏM$Ö½?G+åOÞ€ ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( žhß‚–ßü '±3§´®.4fŠ@áÙT½´ŠÌ©¶SjQ‚¶vïWôrÜsÁV¿Ù{ÿŸÈøÞ6áj|Q—¸/ãSMÃÍÛX»´­+%{«;;ÚéþIi÷wV7wWöÓZßÛHÐ\ZÜÆc’ •du8*À‚<‚+ô 5TÒ”^Œþ@̲ú˜yÊXµ(¶šjÍ5ºk£]QÞÙÞ A®ÈÈùªÔ¬u¶w`ªÕ¼dyU©jnC?NkTÎ)ÀÝ‚ãÍh™Ç:f¤SWsšQ±l5ƒé@Ó$Ò‚Ô‡¥cE"@Õ-)©±ª™ zV-T•‹ö‚ùžôX~Ð_2ŽQûQ<Ê,'Po™E‰öƒL”ùIuª±›˜ÒôX—22ÕIÊC &ªÆnCIØÒsN×!±¤Oaæ–¥—”_SJæª%§Çz†Íã*k޹5 =Ï^k6ÎÊtÌ[‹ž5›‘ÙN™ÎÝ]ry¬¥#Ð¥Hç®ï05”¤wÒ£s˜¼½ëÍc)*''{{׿¬%#Ô£Dä/ïúüÕÏ)½ }Ôî®yHõèÐ8ûëÿ½ÍsÊG±BÅjˆùŽî+žs=œ>âæš÷R½µÒô»Iï5KÉR k;XÚYg•ÈUDEÉf$€$â¹¥&Ý–ç·F„iÅΣ´R»oD’êÙúeû?þÂN’fñwíga­j*`—Oð¼3¼–¶l6J^ð«<ÁŒÃóÁ´9c6õòý?4”±:®‹§Ï¿¦Þ½>36ñØR•<¸KU*%-n­OwÖ¼úNí%Éfçö7Žü]µËù˜ ~µõTÒ§f~œñµÕ(õ?,þ*ü\QÕÚÏI•ïäpNë2$UôËgú þ£?;Æ©ÎÐ×Ðý†xfX|?´Ä.D¿›G÷_™ãV¾ñ_nCÞn†8X×,ÍéÀÿ⎮!ê}Mló“Ã÷zµ×d}lß ¼_âÖµ×ü]©\jWÐ@¶–°NÊÂÕY™-í¡P#··Bí²•c@pª£Šõpù:§¤|qâ<±u­9».½’]—ܺχ>ÚFT6ž Ž¹½ Xö>70âÚ’ûg°iÿl,Ð(´Lî­wÇ ô>N¾yZ»¿1±‚´ùú€¸­³–y­xuãÁvV‰¿É‡B1&µZ®×9ëÿ Á"©ƒYÊŠgm Æpz³‹»ð°VbÑŒ}+žTb–fÚVgŒxûÁײI²©† ½}ëÎÅa“WHû‡::Š3‘×~Ë¿¶¿û0]]ø+ÇZž¿ðvs,ÐYYl’ïD¸9bÖ¢FU1Hçç…™@f2) æ,ß)Àó>hèÏè.âµJš¥[Þ‡â½<ŸUóïÖ_öØý“4? ·Œo¾?ø5´µŠšÒËP[½AD¬ªªtø·]Æô1n \(VÇ9F›jOT~µ‡¡WÎŒRWNÏgª<¼ÿÁM¿b×ã[á3­ÿò%G¶¦ú/-Å­é¿ÀúJý¥?g=wTÓt=ã÷ÃCZÔn#´³Óì|U§M=Üò0HâŠ5”³»1 ª ’Hf­N/fsJ…X«Ê |™íuFA@P@<þÔÿ4ÏÙÃàw¾(]=«ëv°}“C°º*F¡ªM”·Ë2FÒ"¶e•cmâfeÉZάÕ8¹x,,±•ãEußÓ¯õÜþ>t«`ª£ ùœDî~ã”aT"•ŽÚÊp¯2¤ºÂRØôŸ Xn2µË)í*gÒðì3ùMåa¸ç‹g|)Øú[ÂÚTV‹PgŽ* ®Ì±3j-#è-ÂÆDkÓÒ½*iœ®îÌ?þÐ>=µ†­s>¥®¼¾\šN†"žâÑvß2³¨HdÀb·‚ €Å}Ì[ˆÆ«ÓV]Þß.çå\WÆÙ? ICSš£-)-/y&×*ÕZí7}IµòoŠÿm‹þ"„Úx3CÓ<)‘ k–Χw÷3Fò*Ä”*íh\˜†É~ŸÃÐŽµdåø/óüOó±5“ŽŒi+nß<“¿K¥5¥œ_]v·Íšä~)ñÖ¹/‰òÂ6GäÙ¿bóJ®¶*«œŸ~šÞÉtWnÉhº!ëá1˜Çâ+«ØÍ¼Ë áP¸ùEW°2y¥É†Waù?J=‰+2wÜɸðÀçÊ¡Ñ:©æ~f,ÞNsn¿€¬Ý#²›þcœÔ|!î""¤Ž¢¹1 5íí ¥né3èrž,Ìr®e‚ÄΟ5¯É)Fö½¯f¯k»_k³ˆ¿ðS’ÅIúšñªpöÛ‘8ú?ó¹úN Æ,ò<ßY”*Þß·§'&ýo}•­­øÍKÁWXÆU½ˆÇÇ<Ž­=iNþºië¯ä}&Å<1(ãpÎ:jàÔ¯->˵–ïâmhµÜí¼ãÛ6ÎÛÀ~0ŒGe,±Åg­ÎûZÂ<ŒÄä‚20¡² a;@Ù†ešæ8,®®6ê[Ý}Rëmù¶³ºé­‘ñ]ÁøLÖsâš©$›©J+ãzÚJ:8Îé·?im3|ÿ¨_¼gýœº}ÍœSYÉŠX%@É"‘‚¬§‚È ñŠþOÇæ5§‰U(ÉÆiÝ4ìÓZ¦šÕ4õLþAͳ*ØŒR•)5+Ý4ìÓ]SwŠ~k¿ïÄ:\w /%TyIiC•ˆ ’žIˆ’H{ói?ª<8ã¹çT#„Ì4ÄEo²šî—I4Vc¥Ô~áÑ—à}¬ãlD¶ÑMwìŸu·U¥Òôí ÆÚ¤JY1±AÎ}þ•û=:ê6?8ÅåR¨ÝÖ‹sè­ \Ií¡3H9\î5êSškSàñ¸iS¨ùQÕGw£ "±ö5¥—CÊIjŽ?Çß üñKòø[Ǻ¾†ò¥À‚VxÚ9Pü¯ˆUѰYr¬ Ve9V óc0x|}/c‰‡4wùù5ªùzl{œ7Ĺ¿ c–g’âÉ8ÝY§º”dœd¶v’iI)-RkñŸö†ý޼cðdÿÂEá/¼Uàó¤–æBnttMî>Ô©c.MÀ ›•·,yMÿ—çœ+[.ýí Ξ½5]mÒßkEÝ-/ýÝágyoµ—æÊ8\jåI9{•[´våkIÍÙRnR³\²Ÿ½Ëò 79Ç5ñÒýCsR)óŽkžP=z8‹šÍïXÊ'¥J±~9‡­dâzëÒJÍ£² %fÑÕ …•“ÐÔ4tÆ¡:½KGDfL¯ScXÈ™d©±ª™a$Å+©,ž†¦ÆŠDë6;Ò±¢‘eg÷¥cE"ÊÏJÅ)RãÞ‘jE¥º u¥b¹‰Öð÷¢Ãæ&[ÏzV0óz?½E‚ã~ÙïE‚ãMß½ µÑ=éØ\ÄàúÑa\…§÷¦K‘]¦½låÏziÙY¥ô¦Kd,þ¦™D,ôÒ!È®ÍLÍÈßIJEgj´ŽyÈ©#àZEu'c2y0 ožV"­‘õOì»ðöGQ¸ñî© ™µv¶Óf@X©Yd#0ÃlS’3ædd)£pfT¤Þ:¢ÛHþMùöZ÷ÒéÆI^?©Já\Õ¤”ëè›ÝJœ/vâî¹ä¹S·³´¹e$ÿEô½,(RTb¿K„âV&ççÿǬñí½Þ•ð߈—v‰¶4[iþöU?q7ÆTíQ¶@¼•$ü¶e…ú•tãðËUåÝ|ºzÛ¡ûÏgßë>S*u¿BÑ–ï™5îÍ·ÖViêÝâ墒E}ëÎT“<7Jšr¾¦˜Ê\Äõm·²×u3屪ÈõM*>V» —ÅHôí"0v×e4|Ö.[ž¦AÂq]GÍbg©ÙÚ§JØóù‘ÑZDI•2vFô#í%¡ÕÚ•‰A&¸*.cê°’vI=ñ=XÒ…#LF`Þìź¾¬I®¨R<`Ýõ¢Ãæq¢ÂçwÒ…Ì4·½%ÈMƉrO©¦KÝ‚n0µbš$…¦\|¬®óàu¤ÙJ&|³õ©lÞ03¥¸j7Œ ©îzóPÙÓ f=ÅÞæ³r;)Ò0ç»ëÍfävÓ¤b]^`k9Hí§DænﱞkHô©P¹Ë]ßõù« HôéP9kÝ@ üÕ„¦z”pç}¨ýïš°”Ï^†ãoµ¼×<¦zô0ç}¨ãwÍ\ò™ìPÜeþ¥÷¾jçœÏb†á5-Sïa¾‚¹g3ÜÃaµÿàŸÚƒlþ9iÚÄ6ê=nóL»“ÃRM"“ˆÉ”èÛ_šøqf•jbgC’¬ÝÜ£&ô»QÖ}}ÝnßÄîy˜ÞÉólEL^"“Uª;ÊjNíõvmÆïí>[¶Ûz»Ÿjø'ööøqwám{Â_þkKm¨éßÙ× á¹Òâ+å–7Žãr»Ã%ºà»FؼüË(¨ª`ê§guֺ̬^׿›²ô×Og*ÉðÙleìŸ6öOðׯáè|¹ xÓÖzÔú>·s/‡c¸’=/;ÉêU”áN‹W×ËïÛñ>¥ð÷ÄHu( [k•Ø u÷¯¡¥ŠSZ3ò¬~A,4Û©OcмJNÂdçë]ÔêŸ)ÀÚöG§Úêâhr­Éí]ißSççMÓve¸® Iª0jÇç·ÇÏØGÃþ$ƒPñgÁTƒCñqK4žäZj“7âgÅ«mgP€y´¬W1 œÑb¹‡yíEƒ˜<ö¢ÁÌy4X9†­1˜ÿz…ÌDe÷¢Äó™­1s(%Ȉ¹õ§b["/L‡"2ÔìfäBÏùÕXÍÈ®ÏïT‘„¤Uw«Hå©P¡4½y­£έXµá­oköZDo¶"K‡¤ ÅrÍÎ’3ÆM{9N_,~"4–Û¿N¿>ßä~iâSá<¢®9ëS᦬ÚsiòÞÍ{º^Z­·½dÿMü ¶•§iú}”{-m¢HbBŶ¢€ÉÉ8ry¯Ùppq§d’KÑlš¼I‰­™b«c12æ©RR”’¼¤ÛnÊÉ]¾‰.ÇÒzÇœ¨²}ëÙ¤ï¹ù®>Ÿ#m9þÚÞK‡ñE¶4×ÚNª±5ÜAÊÚÛM‡.Ê¥ŽÝw0ûÛ@#v‘ÄTy°Ñª–±rküÒ?Cðk1tóšøÍ(զݽéBJÖ¾­¨ÊnË¥ÛZiò?….L–dý⢼*ñGêù¥.Z²G»øis°×§DølÉÚç±iQ’½#ä1RÜõñþYÛ²ÖÎ^'¦j€•¸ú×ÒBgâxœ-ºÅ­ç óWLdx•h%¥Ø$khÈóªÒ±»Æ1Íh™Å*f½Ï8&­3št͈®xÖ‰œ²¦\IA9™“‹Lõ§qXpnqšCèI“@\vá@Ô… ®`Éõ |ÂäúÑ`æë@¹„Èõ \ÂnçÚ€¸nô –Æ“ŽM; ås&ZE[A ‚X¯$ØïAQ‰E¦ç­MÍ” ’Üc½Kf‘›-Ï^j[:#LËžë¯5›‘Ó F4÷]y¨r;!Hĸ»ëÍdävÓ¤`Ü^c'5›‘ÝN‰Î^_õù«HôhÐ9[Ûþ¿5a))yß5a)ž­#}©}ïš°”ÏZ†ãoµ¿5sÊg±Cq×Ú—_š¹å3ס‡8ËýK¾jçœÏb†â/µ2ìR0]ÏW’kšS¹íPÃr«½»|)û8ø_á·…áñ/Åÿ°Í⛃¸Y]8’ #å¹û:F ÜNr FÝïüûÄœcžñb²ÎŒýž×‚´åï/yËzpNÊ÷޹»>XþQÄœUšãñRÉy£IhÜt”µ^ó–ðŠv[ÇFùÞ¼ª–§áOÄzö•«èöÓéÉgsÝ¥íÄ@HeŽMÑȈs• 7Œœò£¿è¼ áÆ/*Œ1y´íSGEÝ-/ï;jÓé˧Å$ôçÊóG“Ók™N{4žŠëTßWÑÛEmÙéžøg{~u]bêûRÕ'*Ó]ÞÌÒË)YÛ$à9ì~ɇËéGW©åæüa˜WN1´Qõ螂)’‡€ÝkÚ£NöGæY–7‹oÚÏCÒmô[Çú:þUs©cŸ ƒSݳr ÃåøW,ë¾Ç¹‡Ê õæe–·†!²%GjQ“4«J)ÙF¢gà»ÓmRx¼u<ºö‹8¿xóÀ~[ãOè:Ûwý˜kzŒ_hÙ·—æ2îÛ½3ŒãpÏQYVÅÐÂÛÛÔQ¾×i_ï;²ÞÍ3Å7•á*Wä·7³„§Ë{Úü©Úöv¾ö}×ÿl?Ù¯@Õn´{ߊV3][íß&™gw¨@Û”0Ù<k+«jïºÓu}»îÐü>Åf|'ŸácŽƒ¢¥>I9Þ0qmFošê2Œn¤ÜSQ–ªÇ‹lv¯ÌùÏí÷†!k~:U©˜O S– v­#3†¶ȼ´œŒë¥RÇÏã°j¢wZŸ½ÿðL¿Û¯Vñ•ß‚e‰:e¨ÔôÝ"ko ø–ܲ=ì‘FÐØKn‘¬w,.  d·EeiX¼žÅ ÜêÌüç5ËžN¢Øý¶®“Å (ùýµ¼aÿ ö½øû¯ÿe}€ÛkòhžGçoþÎDÓüÝÛWgÙ<͸ùwíËcqðqÕ/6~±Â¸NL-?=~ýOÒ­òÈ1ÅxUev~±—ÑåŠ=wC² ³ \s‘ôT)É¡i¬60}«z0ŽßTñNŸà½5.ïCM}6RÒÅrãßøTdn€z’ô2̲¶i]R¥²ÝôKüû.¾—kä8ãŽ2ÞË%Ç>i»ªtÓ´§.Ë{E]sJÍE5£“Œeâ3¶½ã GûKÄ7²ÝJ]š( o&Ô6X’aTç±'šýs-Êh`)ªtcnï«õ}Nšçwø›qn.X¼Ê³–­Æ)¾H'm!µd¯ÖV¼›•Ûô]@HŸ†+ݧJÇåxÌ{•õ=ËJFº£LùêØ«½Î†ÛJÎ>ZÚ4Î ˜£~ßKUŽkU‚¦%²éÓ†~íW!ŠÄÓWû´r ë,VÓ†ÓòQÈ5ˆw3&ÓÏËPàtÃ̹tµçå¨p:cŠf-æ”9ÂÖr¦vQÅÅÖ‘×å¬%LôébÎvëIá¾JÊP= X¿3‘¾Ò9o–¹åLõ¨âÎRïHå+S=JX¿3•¿ÑÈÙ‘éXJ™êPÆ5ÔæÛN’ÞMñäcÓúÖ<œ¬ôV!TV‘ÙøÅ†Žë‰ ¸ÍtR¯*gË(âÖÚŸDxOâF|­Ò ñÁ5ëPÆŸf¼;kÙLøSÇñÌ#V‘pkÙ¡ŠLüß4È\.Ò=«O×í¥U$‚¡¯B5S>>¾¤]ŽÎÖê)TlaÍlšg—8ÊSø—ðÏÁÿ|!¨ø+ƺÚt«œóà¨×ÍËßxÃÃé}ªKq%±[]]$cueÄìv[Å5šy…™dvwFÁÙÝdpŽ<½[ÔþSñKW;¬ªÿ˸¦£«¶ú»toKè´IkcÔ|x$޲„ b¾ç+«ŸÊÙ½VÓÜú'B¿Ž(Ô–±Ò½jr±ùî:ƒ“e?ŠZL~x§ÁíuäËn Ú¢xÝe‹yÚß'™nÀ'nqƒƒS§õ¬<èßuø­W㹿 bÞAœáó[¨=U®ùdœemV¼­òÝÚö¾‡æ?‚µ§·‹ŒmÀ#Ò¾7$Ñý'œáÜ&üϤü3/sÔt€>Jí¦|Î/©ê:R«]>kΦ6Užkm>îäÂAýáCH¥&î’5;œ­M‘¢œ¤¬Ž;\×ඉǞ¡¾µ•JŠ(íÂ`çZIØò›=7Æu;áÿ‡ouÝR!ûÄ´EnJ»/3‘!„R22î+µrp+ÃÇf4pªõ%oÌýS…¸72Ï*(`è9%»Ù/Vì–Úk¯Côëö|ø,Ÿ<qa¨_éxÃW˜^jÚŒ1*¦ý¡RÞÚ ˆnÛ¿’Ï#á7ì_ÏñøÙcªó½º×ü#Ãx[/XXYÍë'mßeÖË¥ú¶ì¯eï5Â}HP@P@P@P@P@P@P@P@P@P@P@P@P@P@Pägí/ð VøQ®ê<ðÔçᦩtÒº[Ä©ý4‘ "¢Ü³m‰€r#l'Øe¢­F£÷—ãÿ¿ßéüãâO-«<ËЛ»I[‘·µ–œ·Ò/eð½låàºf®*—Èõ¯¥…Cñ,NÎèìí/¾ënâº##Æ«G¡Ò[_g5ª‘çT¡cfž‡5¢géš±]ž9­ŽiR4áºäsT¤sÊ™¢—@õ5w0tÚ,¬ÊqÍ37‰¼Ì÷⋉"EzhL“"‹ âäzÑ`¸gÞ‹Ã#Ö‹Äȧ`½È‹b¤¤Äó§{ ×"y½M+”¢SyyÎi\Ñ"Ÿ¤ÙJ)Épz–ÍcŒ—=y©lÚ03¥ºóRätF‘™5×^jŽ˜R1®.úóY¹”é·xšÍÈì§Hçîo@ÏÍYJG}:'9y¨ÍXÊg£Gr×wý~jÂS=:TN÷Q7ÍXJg«GrÚŸ_š°”ÏZ†㯵/½óW<¦{0ǪcwÍ\ò™ìPÃV¡ªãvšæCÙ¡…8ùîn¯eòm‘™Û¦;ÿõ«·'dzð§ 1枇Ôß?eßxø´×lÖi4lo⌑Ã{`œ×¥„˧U]è|_ñ–%NŸ¼î´ïä~‘ø{öqð÷…"Ÿ]Ônî|Eâû…Qu¬jò½ÌòP£sÈK*€2xc ¯O•á²ÚjŽšŒWD’Zêì–›ê~e˜q#2ƒW䂽£ù+ÚG‚¡¼šH%„nJ¶:ï«£ÈÀÕå“G´èþ¶Ò Vx×ÍŽ”©±ã©­Y%ØËb½oCãñŠò.Ú(Ò²¨ÎüWfŸšã¥aÊz¾Ù%¡æ><ø¥ðÿá­Ÿö‡|e¤èPÕæ¢µÝïmì·!åoʇC)Âδ¯ùbÚ‹“´yåðÁ;=dÒ²m»&~xüEÿ‚˜h:}þ«¥ü0ø{>µn˶½­]8šà3ªH-Uäƒ7ÃI Œ©XÈÍ|®/Œ(Ó“ŽŸ7fÝ•ý7k®éú¿pÿÑÇ1ÆR§[;Æ*-´åNç|¶M§6Ôc=ã¤jE4šsNÇÅ~7ý³hïR kß↔“²ýÞ–Oâ\ÇÌצóT¾½ÔõK¹ï5;ÉžâæîêF–[‰]‹;»±%™˜’I9$ä×ÏÔÄJ¤œ¦îÞퟯá2z:0Ãáà¡N (Æ)$’VI%¢Ih’Ñ!©d¿Ý¬VzÀDZdZ>íG´:– %°}‘Oj^чÔãØCf¾”{F'‚‰Z[A»ZF¡ËWäP6…$‰š9P†VS‚¤t"·…gtÏ+–S­ -nšóEë=sP°š5º‘®- ­‚ÀẒ=Ï·Ó ˜ZU¢Ü¤z˜,ÿ—UŒq2u)uOW¯TÞ­®ÍÚÚi£^ Ãu wò…ÆU—½xòR§'+4~B¥,](Ö£.hËgý~+tôdrCžÕQ‘•Z2nm¸'ÑNgŠÂÙ6ñŸŒ~xÃ@ñÿÃý~ëDñ–‡p.l5;6á|Ate,‚ŽŒÊÁ•ˆ>• œ®èø¬×«EÅ£úÝýÿj?þÕ ôŸéªxëN‚ÞÛÅz Q˜KÔ |åbgvû4¬²42omÈ “æG*'± ©«£óŒNXy¸ÉiÐú¢¬ç<Óã/Ľ3àߟˆ_µuµ’×Ã:MΠ–——«d—Ó¢&ØLÀ…y¥òáO•‰ybB™”¹bäÍhRuêÆ”wnÇñ ·ºž·¨ßëZÞ£u¨kZ„ò]ÞjÓ4Ó]O#y$‘‰gvbX±$’I5òØ™¹6ÙûÎK†:q„U¬wš5¾ç@y5§èx*VŠ=ÛÃ:pÂ3¹dÏr”lzF£®YøKH:œöï<¥„P[§l„laF$žÀà€{rܾ¦g]P§§Vû.þ~Ÿ–çÍñ¯à¸)žkNZòÂ+yͦÔof¢¬›r{$ì›´_•XÚêž%Õ$×5É|ëé°8HPtŽ5þµéÒ«sás ½Fú¯k|“F¬§žõØÑón›§+3Z³ŒÒ±¢•Ž?h¿ØÏÁÿ¿â¦ðd–>ñúyÒMq  ºË¾÷ÿJTÁYL­“p>ÖmË&gÊg\1C3ýåB¦ºÛIuÖÝoöµ}ÓÒß¿øcã¦gÁÁf\جåJ.^ý$­ݹ^ñPVT›Œn—,¡ys~;øïá¯ÄO…:¤Z?Ä/ ßè·’çÉ{…Ö¼™Ð´rí&íŒÛKa°x¯Ëñù^'/Ÿ&&›‹ü£Z=õ³Ðþîá>;Èø¿ñ9..5¢·JêQ»isBIN7å|¼Ñ\É]]jr‘\ç×—(wGsF9óÞ±”J•{—RozÉÄô)Ö-¬¾õ›‰× Å…’¡Äê…Ru’¡£¢5 –J–£T™d©q6BQ'½KFÊ ðô¬Z™ úæ•É”¬R˜á õ¥b”Ço÷ýh±\ㄞô¬>q|ÃëE‡ÎÏ­0žg©¢ÁÎ'™ïEƒœi’‰rd¢Âædô¦CÂþ¦‰s#/NÆndLõIJd øªHÂu,T’Nù­N*•LË‹€ œ×D!sÉÄâTÏÞßø&¯ìD|máoÚ‡âTûüU©Øý¯Âz5¥ÆcÓì® *.îi •‚E’±Ç!. ¬{…öiT–çäÜKž¼\å„¥ð§«îÓÙy'÷úoú;ûF|ð¿í!ðÖóá÷‰ontùâ¸MGJÕí gÓoãGHæ1ä,©¶Y£b7+¶ >ÙÔ¥QÒ—2>‚§¢èÔÿ†gàŸÄ_†ÿe}jâo‡ÄÞ¶Þ(ÒYô«Ç‘„IpÈ›fT Äá– P«·Ò`³5±ø§p4Ós·Ílužø—£j§—såÈ…Ï} d&´gãÙŸ âp²wÑÛéÚ¯‰¼qu/‡þøWXñvµÐÛÜG Ú½Ä6/3:Çö«€<«u-å¥e+1áIâ³Z8ug-N¼‡€³<â¢:-CMZïúvnËG©óoÇÿgÏxoSøƒ§iÖvþ<†]FÚ->ø]}šåJ‹iO_5XÙŠîˆù¸Ø) ópŽiJ6~ÙŠáüNW–Ñ¡‰i¸Å+®Ë£²[+.»nÝÊ^Ô²ÑÕëÑ™ùÎg†ÑŸIx~àK /Ÿjö);£ó¬}>I4z–™v‘íËdúWl%cæ14œŽöÇV ;«¦5,xu°œÌÛ·Öã~°kERçL[ uâK;E%®w¦h•e¥—Ôªô‰ã>6øÁ¥è1IºàK>2[}Myøœ|)#ì2^¯kݲ>lºý¢þ Ænnþ*üJÖŲÜAøgá­œ–¡so5¡œ\ý¶gP¢3Àù¦æFðÄP°øÌÉup¡¯ŸOø'ôÏø"”cˆÍŠé´ýwåôµ÷½Fðgü Â_´X¼=àŸÙËGÒT«46~0 g"GæÌçOÝ,¥#@ÒHYÛhÜÆ¾R®2UeÏQÝúŸ¿à¸v†ŠÃá„E~º¿7«=7ÂÿðZÿ ]ë–6þ3ýžµM/ÃO¿í7ú/ˆ¢Ô®¢Â1M–ò[Û£åÂ)ÌÉ…%†âœþ°º£µäÕ-îËSí_†?ðR¿Ùâgö¡ø”|'¯ê^wüJ¼ig&öO/yýýçÍf›’=Ëþs½ï•q­ u9*åØš[ÆëË_ø'ؾ øà?ˆú]ƹðóÆÚŠ4X.Ò]Cú”„Nª®bi!fPádF*N@u8Á¢iìq΃´•Ÿ™×S$( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( €2õ½Mñ‹«ø{Y¶ûFªZËewo½“͆D(ë¹Ha•b2#<U ºrRŽëSE xª3¡Y^M5Ý5f´×cñ—ãoìïão—ú޳i úÇÂÅ–1o®†[A!!bºA‚¬ æ…±dÁV-~Ç/ÍaˆJÒ}¿Ëü·üÏæÞ0à NO)â(®|=Õ¥¥ÕöR]ÖÜÖåw[7ʼÓKÖQãBnA¾‚.ȱX6¤Õµ;+;ðÀÙÑ5j:;{ÜÍj¤yõ(›v÷A€ ÖªGJV5#¸àsV™Í*e讽ê“1•2üwCÖ©3 S-¥Ï½W1“¤Z[ëNænÂãÞÉäííQqrû@õî.A>ÑïJãän=è¸ùÚãÞ•ÊP kzW)S+½Ç½.cE³ÜZW4P)IsïRÙ¬i™ò]uæ¡ÈÞ4Œé®ýê\Ž˜R3e»ëÍC‘ÑFT÷˜Ï5›‘×N‰‰qy׿¬ÜŽÊtN~ïPÆ~jÊS;éaÎfëPëóV2™éRܽæ£×æ¬e3Ó£‡9;íS«žS=Zc½ÔñŸš°”Ï^ŽãoµN¿5sÊg±C q—ú¨¾jç”Ïb†Èâu ` ß6MsN¡íPÂ\­¥é·ºíÔpÅ•àRK~=?Zˆ§6oZ¤p°mt>ÚøIû;M4šv³w’Æ³ÅæÀ"L•f [{È ݼðIT!T±¾‹•óZo_ëצÿ‘øïqӣχ££³»Ý+ÚÊ-ûÖå[$Úm¤›?]~ø'LѬ`¶³‰4^ rÜu®ÌmeB>Î Cæøc-žiUâñR¼ž¾‡OªéqF\£ëïQ‡®ä¬ÑÓ›ep¡'8JÌäô» h/%mÉl×]UîÜùü“¬ÓgA{4â±¥Ž:µ-®r—F"ÙSÞ½ iØù \©¹]3Èþ-üuøuð?Bƒ[ñö¶m¾Õæ­ŽŸmšëQ’4.R(ÇüK¹XÕ¤@λ†xs ~-‡´ÄÊ×Ùu~‹õv[]£éøC„ó®6Å<KGŸ–Üòo–MÙ9Iüß*¼ÚRq‹³?.>'ÿÁGþ'x‚çRÓ¾hVÐÛ o©ê íG唑 ûˆ÷ÆZ3»rø’¥~ÅÕ¦Üp±Q]Õï¿euÒÏÔþ©áo£®Y……:¹õiW©»„%=cn[¯ÞK–WjJP¾—‚Õ?Ïí_S×c7DâªR9çH¥4#[FGz*×F\Ђ5¼ecɯAIjU·¾¿Ò¤-i9TÎLMÊ7N£ð#šÒt©â¦¾}NL>aŒÊ'͆—X½böÝyÚ×VvÙž£k2ÞÙÛ] e@ØVÝ´÷ö9…x éMÁô?[Á׎? O ¦“ÑÞϪ¿“Ñù¢ £àñWõéhs—öªUˆaÛÖ»hÔw±ó†.-­ÏÓø#ÿÄÏøDÿhï|7¾Öþˤøë@“ìúwÙ|Ï·êvN'‡÷ e£jMË*7C¹¼±^Þ]Ëóê;M-¿¯ò?¥ºí>düÙÿ‚­øÓþÙ#TÐ?²þÔ£ðÇ‹á¼EÚàL×µFº‘ùže”ʋիa©A8_œú×df™óuhΛ:$rØâ›]Lá;ècx»À~ ø‹ Ïá¯xrÃZÑeÜ~Ï})Ê2y‘7ÞŽ@®ádB®»Ž®^Ž2•x)GÏîºìüÖ§Õðöy™pæ*8ì«*5WX»]&¥Ë%´¢ÚMÆIÅÛTÏÊÏ_°&¿áïøÇàÍçö·‡âó.ÿá™]¯­c•jÿ7Úq™HVÙ&ÔUsœŸÏó~>jøxïËÕy'öºïgm=æ_xuôÃbÝ ¯Šcìê»GÛ«{9=}ê‹Oeu7hs7&©AiùÝqî™}y¥êv“Ùêvr½½Å¥Ôm°JŒUÑÑ€*ÊÀ‚ƒ_ V„©ÉÂjÍhÓèX`3JÚ0Äaê)ÂiJ2‹MI5tÓZ4Ö©­,Esž¦¹eÛ¥‰î_I³Þ²q= u‹I/½fâvB±i%ÏzÍÄë…k–J†ŽˆÔ&W©hÞ5 D•-ª„éXÕLxz›*ƒÄ”¬Z¨<=+¦88¢Å*‚îúÒ°ùÅßïE‡Îýè°ùÃw½8›¾´X\ânìâ÷¢Ä¹/NĹ‘—§c726|U$e*„-%RF¨UyzóZ(œµ*™·!A9­¡ ž^#¢×¯ø'ßüí¾ ¶‰ñëãÖ‰ÿÉwáÏßGÿ!ïâK»´?òçÐÇÿއ‘qí`ð‹IÍ™ñ¶Þ -zµÓÉyùôõÛú ¯Pø@ [ÆÞ ð§Äo kžñ¾‡m¬xWX€ÛÞi÷@í•r ‚X++© ŒªÊC(!ÆN.芴¡ZEtÏšôoØ3öNÐu?SÓ¾'ÚlæIãŽëZÔîafF ËpÑȹ(êÊà ‚ ¿Ö«%e#Êy[))JŠmw»üÙõ‡|7áßhö~ðž§h¾´ßö}3IµŽÒÞ Î]¶E ¹vf8–'©¬rwg« p¥$’è´Gñƒàÿ~9øSøñKû^tD°ÜBB\é×*ŽæÚB—*nlC28dwF¨NTåÍ,V–2“£U]?êèþ>3~Îÿfko‹­ï‚®oÓJñ]¦Ño¨aC¨t Ío)Rw'S›EBõôx"[é±>. t°©‹P[ž¦ ‡çˆ’÷O›|uñöÖ[«›™61)Æ €?#ÉÀ÷óø® ÃÒœ©º‹oÓ}öÝ|ô?_ÈWiµË&šwQnZ=4gÁ~<ø£âOO*^NÐinU¾Æ¸3rí€[žqÀàq‘šù ng[í-#ÛüÙýà –ðÌc*Kž²¿¾Õ¬ŸH«´´ë«wzÙØóÄEô¯-¶}Õ:q.$…½2óRÐõM7\Ñ5­;ZÓ®#»³Ô,fh'´ž6±È¤2:° ¬¤@#š¥Q£)á#5f´?C>ÿÁO¿iß„Öz'ˆõk_ˆ¾Žâ&x¼bÒͨE•ä™!Ô„…äp.{# ¡T£o T£¾§•ˆÈ©UÖ>ëòÛîÿ+© ÿி³ŸŒ-á·øŸ¤ëÿ5¡³O%Å»ë~ñ.ÔŠ)íÎîÑä½´h¥]w¿L10–ú-|“GXûËîüÿÌû»á/íð/㥼2ü(ø£ ø†îKynΕosäêÁ¢–[BÜDʀσ½$:“´glÏ6®­j‘höª£ € ( € ( ø³ûF|øö(þ)|CÓtK뽆;l·wŽæm—ì°+Ê"&Í)³ríÝ’øg^ÿ‚ªü8“O·“á÷Â_êú³N«%¿ˆ&µÒ¡Xv¶]e‰îYœ0@ 1;†`(ñüŸã–­©[Ëào…^Ñôq¬–Úì·z¬Ï6æË¬±=²„*P1’ “¸î@<Šãöºý²õMCP½‹âŒZmµÌï,vZ˜b³VbDQ™`y (!AwvÀ™ŽI÷­öþý ìõ{;¯xÀú¯‡—Ú,t´¼ÓîeÊ0]“¼Óªaö“˜› Á;€º|;ÿ‚‡xk\Ö'Ó~(|6Ô¼bØû>­cvu¸Fo=RåNV5_.9rd;¶ÉýÑ5Ýĺe¶µáÍbÇUÑ®7oôÛ„¸†]¬Q¶È„©Ã+)Áà‚:ŠÕ € ( € ( € ( € ( € ( € ( € ( € ( € ( €?;>9þƼÞx·à…¡…Åß›uáš(mö¾ÐZÉ›jŵ·9‰Ûf„)±co¡Ëó©Sµ•×Üùú¸gÑÐZj#æ­c#‚­zõlsZ©œ3 Ñ£Ø=©Hç•"ò]tæ­HÁÒ-¥ßNió:EÄ»Çz«™:DÂïÞŸ1È•nÇ­;’éûXõ¢âöcMØîh¸ý˜Ãt=isÙ‘5ß½Å*ev»÷©¹j‘Yî½és*EI.ºóRäkE .úóRätF‘B[Ìgš—#xÑ2æ¼ëÍfäuB‰—5æ3ÍC‘Ó &%Íþ3ÍfävÓ s÷Z†3óVR™ßKsz_š±”ÏJ–æ/5 3óV™éÑÃ\ä¯uLgæ¬%3Õ£…8ûÝPrws\ò™ëÑœuþ­÷¾jÂS=ŠSˆÔ5|gæ®iÔ=œ>çs{uvþ]²3qÅs¹9l{4èÓ¤¯6z/¾^ø†ò¿GÚØ!qZÒù=N vqNŒ¦ÏÑo…?³Å©sµ²,qÌÅz öh`Ó±ù¦mÄU’otÏ©oôˆ´»X4ý>?*Ö8Q‚Äw5ôtŒlųYJ½GRz¶z—Ls±yîpÈ­äÀ¤—i‘7lVÚ-Írbqxl¾ø™¨¯=ߢZ½Õì´>‹%È3Î0ļ.I…•i-í¤ctÚæ›j¿+åæ’æjÊïCò·â÷üOÅÚù›Jø5¡Â=§œÄ÷ZŽ+›çÿVß$41`‰Pî3nVyl+âó3©/sUüÎÍôéª]V·ºìÏéÎ ú4a(5‰âšþÞóê›”i¯‰{Ó÷jKG._gË$Óç‰ùå«êzç‰uKoÄšÅþ­­Üíóõ Nåîg›j„]ò9,ØUU<A__R¼ÝJ²r“êÝÙýG•dx<§&ŒiRíEF*í·d’Jí¶ôÕ¶È£¶Æ8®YL÷ia¼‹éµbæz4ðå´‡Ú³r;iÐ-¤ üZøyñ[G[©.ü/¬[jOigzÖO}83[”©4FH_å`RFX§ÙÃT³GæÙÖ™Iw?· õÏÏÄÏø,ψõË}ö}ðm½öß jwú¶§wgå!ónmcµŠ 7‘¼lKÛ¡´§ÌËUHóóZ aÁÔULLçÕ$¾ÿøcñƒC²/°â¾Z³?zË`’V=ÿÁú_˜‹ò÷¯:OSëèCÝF¿f3Ëcá‹Fù…Süœ«Ãþy‘_oÁùg;–6¢òêöù&Ÿó&/}#xÝa©ÒáŒ$õv©ZÏÿÁÚ^³”eùõ(³sÃÚJ±œŽÕú](Xþ!Ì1Nmê{cò©"½ q>C[VwÖw宨ÄðkÕ;;+NÑž=j§Q®â¶Q<Ê•Mx-‡VŠ'$êš±[Ž8«Hå•Bȃ=ª¬gí VØŸá¢ÄºƒÍ©ÇJv´+=¯µK‰¢ªVkOj\¦Š©B{Oj—xU1æ±Î~ZÍÄë…c"{ÏËY¸p®s·zp9ùk)@ô)b,r÷zg_–±”N–$寴ÞËXJ©Cq×ÚWÞùkžP=z£½Ó1»å®y@õèâNJóNÁ?-a(­AÍ\ÙOÖ.'¥NµÌ‰!d9PÑצm/S’ÅÃ"0y•p›‰ÉŠÃF²·SÞ|ã–…¢oNýkÓÃâl|6o’)§¡ôï‡nMK³4§Í©¢=jM£®§üWøð·ã=‹A㯠Aq©¤^U¾·kû‹ë@6N¼•V•ÜDû¢,rÈÕææN3±»èÖo×Ê÷³º¾èû^ñ ˆx²©“â\a{Êœ½êrÖ7¼‰ÉEEÎ<µtŒÑùGñËö øðÞåõ‡_ø×ÁϽÊZ[ƒ¨iù”*Fð!-qòº~ò%þ $j?žfÜ!‰Â?i…N¤<—¼µÑ[¯ª]î’?±ü<úEä¼C…ÏÜpx•eyK÷S÷nä¦ÒTõOÜ©.±QœäÚ_Ãx +ãeLþ•¡RÙšQÜÞ°”R–%2âMÓšÉÄî…rÊMPâu¹ee÷¨q:¡X˜KPâo¤¢Oz—XÕ$Jƪ ñ%+ª V-TÞ•ŠU¥b•@ßE‡íßE‡Î.ÿzVh&ï¥;8›è°¹Ä/ïNÄóŒ2S±¡’ŒÝB“Þ­# U+<¾õj'-JÆuÅÈPI8¶…;ž^'¢·?r?b¿ø&N›&™áÏ‹Ÿ´Æ—tÚ»Oþ™ðòåUaެPêѲ–wf(ÿeBˆÂÍ¿|GíápJ)J¦ý¿ÌüË<âiV”¨a»³—ÿ#åç×§wû^‰ñ@P@bx›Ãš?Œ|7âøŠÑ®¼?­ØÏ¦ß[,ÒBf·š6ŽDFÊèJ3 ÊÁ†r<Ñè&“V’Mvjéú§£^LþL> ø[Æ~,øóስ6³áA­’ûÆ/­™V[kƒ;¬~lC/—¸”ó6·Ì¦¡q˯ Rr¶Î)j¼Õ×áÿÕ/©ñ’§ˆÈ*S¤¤­8U”í-/(ÎM=n¥³WM¦”{ ø·ÄÒ°·’òÖ%eÂJÁ¥ÃvÊü¼~5Í[ÄŠ4ThÊRþõ¢¾õÍ÷[æ{9gП2ÌêJyžeF•$¯zJudÝÖœ²$•®ù¹›M%ÊÓm}ÙðgDðv¯©A7‰,ßTqp“ÇäÌ#Œ¿&ÄÚ®™RHpÙÜÀåp£‚ŸæXù{ÓQMZÑVü]Ýþ~‡Öã~Œü”S¡‡z‘—2i¹>–N0P¦â­³ƒ½Ú•Ö‡yñ·á~…¥EsuáýÊÊÚuE•ºBu q“^.vëâRufä–×mÚþ§éÞSÊò9Jž_…§BR²—³„aÍË{sr¥{]Úû]Ûsògã?‡í-ôoíäGn‘—xûŽFNì3É w¯žÊgRŽ6¦®Ûü:þqûˆ8leÃ8Šø¹rÆ1½ÿ¼µµWnVI]s;.§Ã¨2kôfÓWf”1dkHõhQ{ؼ7Rk#¾í–„CŽjޏÒD‚!éSÌj©"A=©s¨¶Eáì.0ÛñÒŸ9/ jøs^ñ7‚µËx3ÄZžƒâ[-ÿfÕ´kÉ,îm÷£Fû&Œ«®äwS‚2¬AàšÒ5\vg|¾U¥×™úeû8ÁT>5ü2ÔíôŸ²]|Fð‘kdŽæÞßTÒÒ6UiÒq7Žb/¹n|ލ|èÿx_®–1­%©óØîŒ×5Êÿþ_/¸ýÖøOûY~Î?îaÓ¾ü]ÐuMn{‰m Ñnd}?P¹xâ9ŠÎåcžD匈…>Gç(ØïHOágÊWÁb0ßŃ_—ß±ô=YÊP@Ëø×Æ¾øuá]sÆþ7×-´ é‹ÍBì±.@ 3³UE™UAbüøãÿ0ø·ñ>]GÃl<#/™Õw,ú½ÜGÎLù¿r×tomˆc’<¤äø³Mðn§âNó\×/nubþwº»¿¾•¦šægbÏ$ŽÄ³;1$±$’I4횀෠ûHö ZÒü&¥U|¡¥vvÞ "ý(v0Ñp}¨ ¯‡ªrD þcÃgÇß ¯§Ö~ø’ÿDÔ\4ÚÑ\adUó¡pÑË´K!Q"°RÛ†4÷'Â_ÛÃZ¼>ø¿acáÍLí[}jÌËö§iYB:6æ·ÚÎò2²34@*¶l¯lõ+;MGN»†ëOº‰g‚êÚA$sÆÀ2º0Èe ‚àƒ@h € ( € ( € ( € ( € ( € ( € ( € ( € (ãïÚKöX³ø¿,>/ð]Í–ñ*/.9®.·%¶«Ââࢳ ~äI*¾[64~¦_™Kùe¬?/OëÏ×àøÃ‚hñ}½ Bº²»ÚKûÖMÝ-žžëÒÎ?•ÆŸâ¯k²øgÆú E“ökøŠyª“̾쑖G "´àšû >.hóAÝÎYÇb²Ê®–&›Œ—F¼ÚºèÕÓ³WO£7lµ`UrÕ߇ÉÖÂ5¶ _?ku\=·FÜäsºµR8g@ÔŠÿ=Z­Hæ•üw`ÿR‘„©–èÿz«˜ÉÒ'[£ëO˜‡H”]Z|Ä:Bý¬úÑÌÈ>Ö}hæd1®Ï­.aªDMv}hæ-R {¿z\ŪEg»÷©æ4TŠr]ŸïT¹F‘B[¾¼Ô¹Æ‘—=ðùªލQ2'¿ëÍfäuB‹s¨õù«73¶žçîu¿5e)ô°ç7w©Ÿš±”ÏF–Èåo5^¿5a)ž¥)Éßj€n%« Lõhá|Ž:ûVûß7Ï*‡±CqZ†°ïž¹çPöpø;ô8ÛNâòo³ÚFÒÌ{/a2O@9ž+ÍÉÙÅ<4(Çž£²þ¾÷äQð7ÁøËKØøK\×4xf6÷Wö6Ò.—¦È3ý²ÿˆ¡TI#‘ÞI#H׿fÙóPZöþµb”s MÖ“ŒÛkÓ]}Ø®÷¾šû§®|6ø{²WPÔ4 ;tŸU°¶E1¯«8'Ž:®@õðøu%Í(¥ò?9Î3yQ—²¥ZR¶ï™»¿/%߯¥›ûSÀbMB)ŸqÒ»á…IÜù\F})SäOSí=Ãðiz`ŠÂŒœuªud£`êU£*Õwg'®XÞBó^• ]šÑtÛ3­-„J9ÐÏ"š¾¥]VþÏJ°¾Õ5;è,ôË8ž{›»©( ‰fwv *¨’Nšnq§9»%«o¡1Ã×ÅÕ†:“j1ŠM¹6ì’KVÛÑ%«{š?o‹}}GÂ_Ö ýZe¶ºñMäK5¢/hk ‰˜HÇH<¯Ýp³#†ñ…:7¡—ë%täõ[}u׫ÓM¤Ïéÿ þŽ8¬ÁC5âæéÒ’Œ£B-ª[Ú³kÜN+à‹öžö²§(8¿Êí_UÖüMª\ëž%Öoõmjço¨jw/s<ÛT"ï‘Éfª¨Éà: üâ¾&¥yº•då'Õ»¿½ŸÚy^KƒÊ°ñÂ`hÆ•(ÞÑ„Tb®ÛvŒRJí¶ìµm²(­Çs\²™ïRÃ%лÕ“™ÝO^ŠÜVR™èRÃéY9° YHG¥C‘× …‹Ú¡ÈèTIDB§˜ÕR#”®h©cö¢ât†까Ý2NµI˜ÎG^£µh™Ç8å@+H³Š´,gJ½kx³Ë­.dæ·‹<šÐÔɸŒrq]0g‰¦µ]ÏCðtÉu¢-°À’ÖFBdNàHíÔø ¯2ƒ…~~’ÿ†þ½OÒx+^R¨+)Rm=nìß2vé{´»ò¿E£ylʬxÅaNg«Ã4›<ûWNŠöpÌüß9§£?°/Ø{Æz_?doÙï\ÑຆÒ×Ã6š+¥â*¹ŸOSa3¬ÃcKk#!ÎJ$)%G¹x£òÌT\+I>ÿž§âÿü£PÒµ?ڳÖÖ•­Íޙ໠KèmæYÎsw}0ŠU(æ)á+`ì•£|œÊ^ò^GèIºS·—è‡|9n‡Ë¯œ®ÑûFWi¡îšˆðî…q~‘«\°Ùn¯Œ<§îŒdR;A"§-ÀË2Å‚Ùîû%¿Gè¼ìiÆœSG‚ò FmRÜñV‚v÷ªKH«sEµzI;ò)5±CÚ|²;Ý\÷wÒÉ!P7;“€02IuMhmOi“ªjÃkÒ´HæBà¶ö§Êdê‹qéO”—Pw1Ò…ÎÈšÜzRq-M•ÚÝ}*lZ™R[LóŠMF©™5Ÿû5'L+sØçûLûß-sʯCq·úf7|µÏ(Å IÇÞiøÏË\òëQĽՙä~5Œ¢z”«ÒÀÈr8>¾µ›V;#4÷cy%¬¿+•9û§§áDdÓj1«UÏgðd¶–8¦sÁÇ&½>&ÎÌøìß&U"å}oáEq[fHÇZ÷hWR?(Ͳ¹S“º=¯FÔDÒF¨ÛWtÙòØšn1}@Žb£´”{T«ò«2c&EM]K¢&z¤Œ¥3寎²Ã³Þk×ðO¢øîH•Ä:aù¥(ޱ‹ˆOÉ2‚É“òÊV$A"¨¼<Û‡0yµêMrÔþeé¥ÖÏðvI]#õ?üiâ?”0˜y*Ø4Ûö3Ù^IËÙÍ{ÐnÎß4å):r“¹ù5ñöYøãðªßPÔõ¿ ÿiørËMk@—í^F@ÑÆ\4’Fˆ õÁRß™æ71§‡§*•%h£ú6ýŒ¿à¾øøÏâÔŒ>/½ÂÉi:Bn¬<>‘J'³F¬nK"Hn +¡# ¼ÞÞ :ËV~_œñ\Åû:W?ÅúÛ§—Íô·é…v:P@P@~-Á\~xa->ühƒ^Òìüoj_B¹Ònïâ†çWÓwù‰-¼2L¦O³O9°DîVü;•HF<œÛ «Ræê¿ðû9–[˜{'ðOððCòŸÃ:žå‰Ãr1_›ã(ò¶kpÞb«ÓÙöwÂ5µÅ¤‚Lm kL wŽ>)ËXI[sôyÖøŽæÞ?©*úÿξ»LM4;ÅÏ%Í{FOñ? ¿m}Iô?iž·ŽHÞX¿´n_F]’$7#rHÌ õzÖ960«ì7HØ+ö»½¤«Ü2’¬JÅ’ÒI(™ø7Á¸ò‰‹ñÅ})áï,k¬|}(Ùto+„Ì|ý(Òôß"Ê~”ÜYh`€<ºÝ‹Ãý>J¶ÞÜŸêÿJΟÃYÜ<¿Ò€<ÿ]ðE½ÈpÐǸÙüøÍ«| Ô¢ðÇŠZ{Ï…·’“•V’MF9ibQ’Ð’I’!ÎIt·, §öW¶z•¦£§]Ãu§ÝD³Áum ’9ã`]d2ApA  4P@P@P@P@P@P@P@P@P@ËxÃÁ>ø¢ÏáßxzËXÑäÜ~Ï{)Ê2y‘·ÞŽ@®àH„:î8"´§VteÍMÙœ˜Ü1¤èbé©ÁôkÉ«®©Ù»5fº3òÏã?ì}ão‡ >»ðÓíþ-ðjy ýŸ´Ï«Û3eXùqFxÃ;NSlm!úluû•´}ú_בøgøc[ Þ',½Jz{»Í>º%f¯ÛU}¬œ‘ô¿Ã.ÖŠ`sÛ5ô¬žÇ䬺PÒHí­µ¨ÜšºUKž-LFÔˆlmzÑLãžÛš±êÇÍV¤rÊr=GœT¦e,9y/Æ3º­HÂT …úŸâ£˜`<^©þ*|Âö, âÿzŽa{0ÞïQÌR¢B׋ýê\Ū,®÷ËëSÌh¨²”—㱩r5„º‡_š¥Ìè*}G¨ÝPæuCdM¨wÝY¹pØ×_š³s:éáÌL üÕ”¦wÒÃ\æ¯5qα•CÒ£…9KÍW%ÿZÂS=J8S‘¾Ö@ÝóV¨zÔ0wèq·úâÙ“õ®yÔ=z&úøGÃ^8ø©âK|9ð¾¥âϵ¾Ç¦@eòPÈ‘ù³?݆ ò id+î˜ 䫈ŒÛ>‡”VÄIFœnÏÔŸ?ðKYîN›â_Ú+Ä¥W÷sÿÂáɹÿ–2yww¸ÿ®ñI¸þëÇq^e\kz@ûŒ¿†cNÓÄ¿’ý_ço“?J|û0~Ï?í4Ko üð¥´ÚEÀ»²Ô.´èïo`œI欂òpó—WÁV.J…P¸  r:µ%¼™ô4òü-&œiFëgk¾û½OÏÚ+ã¯ñÓÆžðÌ÷6¿ ü=,ö„ÚÞ³Eâ9VT>|«˜¤…^0gq2dØŸW”e~ÎÚ¢×Oø=ÏÀ÷ K¸R°FXŸÞ?Q›Œ…+Îͳœ.SÕw›WQ[¿ò^o³µÚ±ö>xmžø…]G/‡&2Q©Z_ 4»²ºs•¾Ìvr;„d¤~2|hý¦>*|p¿Ô¡Öµ«7Á3LÍoá]>]–ÑE˜Ê,ÅB›–$}ÒäÜQchüÃ6â ^g'K–ŸH­­¦ÿ͵õë²G÷_‡þpÿR§V…W’æ¯5y·i&à›j’jN6…›”å6¹ŸƒE1_?)Ÿ°R¡büpt¬e3Ð¥‡/Çb±r=tKqÃY¹´èRÉÈî§@°±T9Q¤XHýªŽ˜R'Š››ªb„®R¦;`¥r¹)Nä¸2Õ&e(•ÝjÓ9§¤‹Z&qT‰FQÁ­bpUFt«Ö·‹<ÊÑ3f¼O*º2'\Šèƒ¥k}h—Zu«Ïg2Ì‹<m¤3DYIã–9#uꮌ§^&g/Þ3ôþ¥þÉÖíþg’x>Éî^/—åȯœ«+Ÿ´àh¨$vú­ØÔ5xtˆ›;‡ ~W˜ãwBAÚ0¼€AÞ;×ßðŽ[ìh¼T×½=¿Ã÷uzöjÌþBúDq¯öže ‹ ;ÑÃ|VzJ«Zí&Ÿ³º®”£'R/CÒô ª‡÷Ô¢#cë]³×4k=ÅIW}8Ÿ'Œ­dÒ=;M¶ÆÞ+¶ù¬MC³³·éÅtE=j‡Uil8­¢.­C¢·ƒÇ²GŸ9ÜÔŠœU¤sÊV5"ƒ8æ­#žS¹cËö ‹Š#ö wå{P+Œ0çµR#û7µ8Ƕö¢À¦P–×Ú¥ÄÚ5LÙlóž*NˆÕ1î,úñY¸TëW]x¬ÜNêuŒ»AÊÖR‰ßJ±Ê^éÿ{ŠÂP=J8ƒ“¼Óºüµ„ z”q§~Zçœb† âï´ÜnùkžP=Š“½Ó±Ÿ–¹åØ£ˆ9[»¹ùkDôéV¹ÏOm´ç‹G¡ —!Šâ[wR¤î¨¤›EÊœj+3×üã9¬ž Ó|¹õ¯Cˆq>K7ÉãY;#ìo‡^6ŠâîžQ¹ÀÚI¯ ˆRv?#ÏòyQƒ’[æ¾ b üÒ½h|wÔ›Mê–é H_%¸T–>€U¹-ÎhÒ©'ËØ邆›%AÎÑéM;nKŠnÑöIÓL‰D¥sxi9Xp¦äÏ–~+þÏþ"Ãq6©á[}3\šY'mkAD²ºy$uyB¤ÌÅH&Ur7±\&¾2ȲüÁ7RšŒž¼ÑÑÝ»»ôwóO­Ø8'Å~/á Æ8<\ªÑŠQöU[©MF)¨¨¦Ô©¨ßENPNÑRºIš_e¿ˆ¾ ¸š]HZ?¹þoô?±¸?Çìƒ<„iæIá+6•¥yA¶ÚV©¬’³“œ`•÷i6|ñp·zuÔö¤ö—в[ÜÆÑ¼gÃ)Ážõópó¥'Ŧº=û®8ÃcèÆ¾¤g m(µ$ýºd‰sžõÎàzôñWêYYýë7®‚ÂÎz‡¦5Ó&{Ô¸›F± —Þ“‰ª¬zò½¶]§õ~ì÷ZÐã ( € (ó#ö°ÿ‚ŒøcàÞ«­|4øG¦[ø«â¾ŸÃL³û5ÆÛHík˜‚€\4¤.îIg-ëPË–ö?=Í8Âm¸¹»k¢ÑkÓM׭ΣáŒh/„ÚjZü<ø«®éšU½¼°C¥I"ßXÛ$’y®ÑZ\,£—ËoT ó?8vÏwöL*«É,¼CÄ`f£Jv]ž«î¦§|Xð·Ž>6xâãâÅj&ñKAª\Ü`‚0vEQŽ4³wr ;Í,ŠŒ›æWûÏr‡ŠÙ•§Fj/½¢ÿ8ÿ™Æ·€ïtŒ¶é'–ƒ>_,H­|ÎyÁØj˜iÕÃÅÆqM¤®ùšÖÖwzì­m_]Û¼,úHçX<ï Î*Ó©…­R”¦£OÙFO•ÍN*1J7RŸ:’q“…Ü@ð.¶m®bø$Wãp~ÊgúWˆ‚ÆáoÕ¥¿>!iºfŸq>»©[ÚhöÐ<·wWr¬QA ©.îì@UU–' šúÌ®½íùŸf¥YimoÚÇâíoñ·OøÛñcRºð¤þoýÞÛE•íM¼—*Á<Û‡ KþñÓ*i¬yDrùú4#‡M­Þÿ¡øöe›WÎ%N»¦½Õnöæ;/’Z'{üá ֔ʡMSFœK¸g„V”9•ˉdäwB™8J–Î…QO1ª¦8!¥r•1Á)\µL_/ëG0ýyFŽ`öAå9ƒØ±†õùŒÝ µ¾j”Ì'†¹é_ >4ü]ø­Í℞=Õ<7>>Ó£¬–×»RDO´[Hö ¤)æ#lf,¸l襈•7x³ÈÇeqqå« ÿ]èþ¿eø)¯€>:ë~økñ#Bÿ„/â~¥¶ÚÖági:½ÈHÀŽ)‰ šio.¸DA4’:¡õ¨âãU¨½ðŸWÀÅÕ¦ù ¾ô¿Tº¿Á#õºÏž üTÿ‚¬|~,|5û:xgRäùz׉¾Í7×ì–’l—ý뇊XÿçÒE4ùoàm ±‰™2O'Šú¿ÃZ2*D»ú ÷=Cf€=HÒù(ÑôÝ(0PWšíìt_»òPUm¡†Q”æ€5B\ceA/‡”ç÷tÊê^v#ÈúP’x£Â±Ï ±Id#@ÿì©ã CÂ>)ºøQ«ÞÏ.ª¤—Z$r3:Ú\ i&…CµdMòòʊжiI  tP@P@P@P@P@P@P@P@P@P@IñGàwÃ?Œf/ørµD‹Ê·Öí?q}h.É—’ªÒ»ˆßteŽJ5tañupÎôåòéý~'›ðþ_žC—I7k)-$·µŸevìïêÓ?-þ'~Èþù—þƒþŸ &?Òt[v[ØÿÕ¯ï,²Îrò0SKòÆYö+ép¹Õ*ºT÷_žßùØüG=ðϽL*öÐþê÷ºo^ïì¹h®ì|˦øš9‚”˜gКöáY3óF[(nŽ® {8É­ÕSʞƴ:Â69«UYá4Sßæ¯œçxo"ÊêYþ*|æo L5:š|ä<8KÞŽpú°Ã¨ÿ´hçÕÈŸQíº—9kT}KýªžsXáŠRj=~j—3háÌÙµ03óT90ÃêƒûÕg\0¬Ç¸ÕÇ8jÍÔ;)ávëW<üÕŒªô°‡3y¬ã??ëXÊ¡éRÁùµÞ·×æ¬%Põ(àŽBÿ\_›÷ƒ?ZÂUZ† ÈÕø}ðãâŸÆ½f}á_‚õ/ßô=¢ª[Ùå$uóîd+;„Rów•*¹8ÇW/yŸI—äµ±Rå¥ÿ/¿cô§àOüÚæèéÞ%ý¢üNU?w?ü!~›þ¸¿—w{ÿâ’;qý׎â¼Ê¸×- }Æ_ä”ñ/^Ëõå÷Ÿ­_þø áW‡-¼%ðëÂzo‡ü?Öû.›ÎF‘ù³?Þšb‘ id,í´by®)IÉÞLúŠTiÐ%8ÙµI©ùOûI~Ô_5 ÿ„ßµ| Ûë>$µoù vk{gòëÔ<ƒýw!u“?ÒåSœ•Z«Ñ~§â^"ñõ<=)åøé´¤ºÿuyw}vÚ÷ò¯i^ Ñükaà½[Ã6VÞÕ´Ñ>•®¥Ö^âö&ÌÖ’! E¥Eå-äp_çX~¶rû E(µ£¿^«îÕy&õÖßÏzx\Ç ý«J¼¥^jpqÑAü3NîéIrÉ¿µ8ÆÑ÷]O±lM¾‘h¶¶ª2,;Ò »³JÙ¯³,Nzé¤7f{×§M%‹œÝohO=ë¼h¹ÀšˆRIÜèÄc¥R 7?.¿h/ÛæÓIŸPð‡Àä‚ÿU‚im®¼UyËhƒËÀk ‰˜HÇH<¿Ýp³#†œñ|(7G¬•Ó“ÛþÝï¯W¦›I;ŸÓ>ýñ´iæ|]zt¤£(Ћj£Öö¬íî'¬"ý§½¬©J/ò·VÕu¿jw:߈õ‹íWZ¹ÛçjÃÜÏ6Õ»¤rY°ªª2x A_œ×ÄÔÄMÔ«')>­ÝýìþÒʲ\Q††B4©FöŒ"£vÛ´b’Wm·e«m‘EN+–S=ÚXrüp{V2™èÓ×c‡¥e)ôèR.œVNGt(–Ò/jÍÈì§H´±ûVnGd)¬U.Fñ¦XX½ECfñ¦J"”®iÈ8GíEÇÈ1EÉ“ó¦C‰/Z¤Ìe»Š´Îi¢œƒ­hŽ*ˆ¡(ë[Ež}TgJ:ÖÑ<ºÈÌ”Vñ<ª¨Ì•zæº"Ï*´w1îW9®ˆ3ÅÅFèöø/†«¥Y_¹–0_h èÀg°`E|Ìé{ Ò§Ùþ?÷,.=f¹}Zjòн®—6ÒJúÙI5×ÕîqâŒW¥…zŸŸFèýÖÿ‚)øÏT½ð?Ç¿‡s[Ú®‹¢júvµo2# Þ{èe†UvÝ´ ]6 ( ´™-• ôwxØü7‚UT»ÿ_©ù_ñÞÉ®?iïÚ$Áñïˆ3ÿƒŠðs jHýc„R§‚£/$vž¶‹GÒîuI•v[DdÚî9…ÏbN÷5åQÂË^cöš[^ÝßÉj}öcŸRÈrœNgZÍQ„¥g%f—»»ÙÊVŠÑ»µdÞ„>¶–âgº¹;î'É#à ÌNIÀ÷&¿eÂP q§e’ôGù«Ä9­|Ï[‰—5J’”äì•å&ÛvI%vïd’ì{®…iò¡"½zQ?;ÇUÕ£Õt›sò|¼Wu4|¶*¢Ôô:ß ¼s]pGÎb*juÖpôâº"*´Î¢ÎœVÑG™VGE \JÕ#†r4â‰F*Îy6Ëê8§td?Ò‹ŽÂ€iÂíÁ·ÞXLa¤w ²nê(Ü[d€sÅ&‹S2çµÎrµ'D*XŸ³ëÅfâu©‡ugp+9Dí¥ZÇ9ua׊ÉÄôiW9«Í?ùx¬eÒ£ˆ9+í46ã¶°”V†&Ç}¦}á¶¹åס‰8»ý7¾Zæ”f†$ão´ünùkžP=Šƒ‘¼³Ûž+ Dõ¨Ö¹Î\[c·ÐúV-:†Ú%µ2dÕGó7q7öqª¬ÏQðŽeÓ®-äóˆòØw®Ü>%Á¦|Îo’G FÛŸci>1Qµµ»Ž`CO=ë߆!M&~G‰Ê%†œ©´zN…â(´\¸,ØÔŸ¸;Ÿ©®ºUUîÏÇàd¡ÉMzùÿÀ:{rÚ[s%¼êê{©¶•DÕÑæÒÂN3åš±š|B‘¾`ÝõéSíloõ=lf\x’<Î1îjdoO.‘æ>"ñ”i¼+z㫈Hú\¿'”­tuÿ¾øçö‹kñßárÞku²./‘w‰†œ…J»+ ŒÌøÉsE$Uó–sW§OY~Gî\á­\{†/¹(ßoµ/NË£oäÖ½GáÂísÁžøyâOhZÿ‚tíâÓtÙGªÃkäDa‰€¸K¬e—Ì$¾²N㟟ïrÖçô~}R…uE$­Ñ-‘ùñ³þÿð“ÄvšÆ­ð/Åz¯ƒ¥ðkU×4¨ïÚ ÿ¼z×Úñ¼¬ÉonÍr²ÆX<°Çʬ˜-qÏ 5ÐúL6‡©£ŸžŸð‘õ+mOCÕ5-[ÓîtýkO¸’ÖóO¾… žÖxØ£Ç,l#«)VRkžTšÜö©cã4œ]Ñ\ç½déÅ\°·õLq$¢zN«C7‰5¼9 ø›ÆzÝ—†|áíO^ñ%æÿ³i:-œ·—7öEfm¨ŒÇáT“À5¤i9;$rWÇÂŒ\êI$»Ÿhü+ÿ‚n~Ö¿máÔdðM¯‚´Yà–ho|wrÚ{»¤¢3Z"IuŸ™”É !DÜ ›ºéà§-Z±ó¸¾'ÂÑvŒ¹Ÿ—ùíøŸ¶_³'üÃàìõŸ­ë6¾;ø¥mp× âÍnËjZ,rCöK6y#ã0ÆË6Z`æB$Taú4°Ð¥æÏŽÌ3¼N=µ~Xv_«ëé·‘÷Ít8P@P@<ÿµçü'Äÿåñ_ƒoý“ð†çmƹåÉ£¯Ä7‰FIE¤¹Qåí²'ïVY … 5šrÜøìÛ;rŒ©ÒÒú¿ø}ì|U௉ HbÉ=N+ÜÃaï©ùvsœò¦®}=ᯠ[Çå™Pœ¯f·?4̳IÊü¬÷m#G„ĉA@¯N5m‡ÅâåÌÜÄoÛfHÀÉèEÁ fÓµ›(j>‚ö_%wã°àÔO ¤ðùä¨Ê÷ÐùÆ^¸ð'ˆaEȰ¼Ý,'噆WpM;ñ×bc•J_ëy-•ý褺+«h´vÖÍŸì§ÑKÆ7â‡ Ë wÆày)TwœH8þê´¥$ýùòÍMsɹÂS|ªqŠóu]'Â^ðþ¥qku­Æ_R’ÝÊ3YržI;yY[ví¬ØÊ°+!›†è{U,D¶Z/_ø¯‘íøÕ𬥔ÐvEÍ+&©-¾ÓNöwJ6jÒ>-µ‹¥}5I†a)^Æä0Ž8®YH÷èÐ]Kè¸À±lôah‹J+6uÆ$ê•-8N*.n .ÁEÊäC‚JE(¢M£¥rùn(¸ÔÙíJår åûQÌÈiŒzSæ¤DÐíT§cáÔŠ²Y««FŽJ˜%%f}Ãðþ !ûFü·ð·†_WµñÃ-Ý,aðÆ¿ ‚ÐJ­¶ ÔQ::Æ(¼Æ–(Ñ€0DUô¨ã§&îŒÌø[WšP\²}Wùm÷ZýÏÝß_¶ÏÃOŽ_¾ |eÓtOMYMuâ/ Ë-´÷–æ+O´»@AæBûfŽdù™TÚqêÒ«Ѻ>0ËêåÕ=Mo³þº÷Góƒâ¿x“ãÄ|DñmÇŸ¯ë×Ò^Ümy!Ü~Xbó™bÇ;QsZœ¼x+E¤LR€>’ðæ›þ¬m wÐl6ª|´ë:M€m¿/4é:^™÷p´è:v˜Q·Šëí4žŸ%nÇ¢ç%hìP;}¢cqÙ@g¯h"@ä'4óŸŒô‹ëmu="_³ë:mÄwÖW>Z¿“q¶°*pÊ ÷€?H>øÎËâ‚ü;ãL1êVûä¶%›ìÓ))4[™T¶ÉQÓvÐnGPe@P@P@P@P@P@P@P@P@P@PüYýš~|cio¼M ?¾?â¢ÑYmoN<±ó¶Ò“|‘*5j’i9®¼>6¶àzv{^‡Ïç/–çi¼M;Où£¤ºnöz+{ÉÙmcóãǰ_Åï Â÷žñ&—ã x㌛9ö]ä’4›XF’;BUP‡,Ó) 0 HPÞÕîJ‰¯ÇúûËó/ qPNXJ‘¨­³÷e~Ëuór^þhñ—‚>&|/™âø‡à}[E…%Kq4>eœ²¼~b¤w)º'm¡ŽÉX zô1ô«ü¿ç÷n~}šð–a•·õš.*ö½´»W²’¼[·gß³9h¦c³©õø.Ä7ûëAzÝþýÑÏ„?ðNÏ€ .muŸØÝx÷ÄiJÏâ¡–Ì#t•â±U”s!!'3”Ø…X2–n ˜º•:Ù_‚áìÍÇ™ùí÷m÷Üû›LÓ4ÝNÓô}O¶°Ò, ŽÚÖÆÎ%†hQB¤q¢€ªŠ  W+wÕžäb¢”b¬‘v…|‘û`üj½øQðþ×BðÙ#ÆÞ1iôë)–I¢{ q'»ãÇæD¨7©*¸Ü#e>Ž[„úÕmv_Õãn þÁË›ƒµJ—Kuemdšê®­ªÕ§­š>øE൷¶¹º€F€M~“„ éÅ6ñm]WN2¹õåŒ+ ºªŒ0ª«.iài*TE“ëJ!TòÏŠ¿<ðÁúüo¨ý›J¶!"† {éÈ% äl €fb¨¬Ãz’Õ·¤a¼æõ´Uõz¶ÚŒS“Iþ"~ѵwþ:j®ƒ¦Ï>𥦌Ûh –ìDĬ·r.K31 å1)Hð“ÍoÌ3¾#¯™¹Rƒå£ÑuvêßãkÙi»W?ºü/ð[*àzt±Ø˜ªÙŸ5MyaÌ’q¦ž‰%§;JrNZÆ2ä_.Eâ¾ZS?x£‡H½5‹‘èS¢_Ž,t”¤z4¨Ø»>Õ“‘ÝN‰v8k)Hï¥D¶±JÍÈì…"ÊGíPäuB‘ebõ¨lé2ÊÅíRÙ¬`N°çµMÍ” D4\®Q|¬v4®>Q;’âWdô¦™”¢U‘{÷«LÂH© «L娊’µ¢8ª#>QÖ¶‰çVFl¢·‰åÕFd£“[Äòª­LɺÖñ<ªû™S tDñëÄô¯¤Òørá·3$wNŠ Îѵ§$ŸÆ¼|ÊÑÄ/5ú³ôŽ ö•2z—m¨Ô’^K–.˲»oÕ¶fk!óÔV˜w©Çœ«ÅÜý¦ÿ‚$ÿ­ý§¿î\ÿÜ¥}f~=«TÏô?24ýkÙÃªÜØéþ3µŠî."ð…ö÷´X€oø÷ y]Ã0E…drPŒT2§Foßl¼o†°Ðo ½öm¿Å_ä¯èxö‹ñiwWúN©,ÖZ¥„Ïmwc~o-´ÈÅ^9#p]YH*FA8¯Ž„•ÔÉs~ÄR¨ã:M5åýXŸPø£aܼ‰YÉÛº@ ­%ŠêrPኲÞO"†•âSÅ®áë;Í_[»môÝ.º¹¸ØŒî#†0]ÈEf €¤ö®yã¡Í)Y¶…±ŠŠ NRì“gè7ÀسÄW> ´ñ‡Ç›;(ô{?ÞZø9'K¦ºduù“1@Tq;‰<À$*â“ç1ùìœ(}ÿä~ÏÂ>Ç/œqY¢M­T7Wþ÷GnÊéõìÿO+À?] ( KÆ^ð'Äm.ßDø…à­Å, w‡ˆ´Ø5#UH±Ê¬¡ÂÈê áØw4šRܸT7x6Ÿ–‡Â?¿à–²gÄ-Qu}/D×üu%ÅÅÍÔ~ Ô–(.ÞVVÇ‘sñˆClމ9 \e†§.‡¥C:ÅÐV濯ü ~';1ÿ‚0x&÷T‚_‡¿õíEê²Úø‹FƒXçÜÄºÍ –ª¨T c$c¸î ¸Ë³= \M^+÷Mù;™óï‰àŽm5Ëë|Qð«á´Ùökýe¯´Û™rŠ_}¼p\"a÷¨ÄÏ•ŽÒJŒÞôgu>(§o~ ?+?òü›GügöÞóDOþº/ÿ%Ö?S©Øôa?›ðä;þ³ûnÿÑ?øRh¿ü—KêU;þ²àÿŸðä/ü;göÝÿ¢&ð¤Ñù.©TíùýeÁÿ?àÿÈö3þ ûRê:^›uâ?‡ZeÝͼsK¦ßj×­5›²‚bÃi$eÐ’¤Æî™k0Á6°îŽiñ^6£?»üÏUðwü—Ç÷ú\òüBøé èšÐ–+_èóë<T‡i¥’Õ•ËdªwÅWHà;³’¯kûºm¯7oÑŸWü(ÿ‚HþÎÞ·†ãân«¯|BÖZÞXgŽ{‡Ñôýæ]É,P[8c{™îvÚ2¡6†œwÔóqGŒ«¥;E}ïñÓð?I¼à/ü;Ó'Ñ>ø/BðÆ<íu-‡‡´è4ød˜ª©‘£‰UK•DRÄg£°®¨ÅGH«ZÕ+>j’r~nçYLÌ( € ( € üKÿ‚”~Ø­#Ïû9ü!ñVYŒÖÞ5½Ó—ýÕ]6;€ßõ×í*«ýÈ‹ÿÇÄUÙ†£zKÐù¼ç1QN…)‹ü¯ùýÝÑùgàß ³^d9'$c’kÝÃÐî~Uœf©]EŸ`ø à … aã¥{ØZ6?$Ï3'+»ê}O£xZ牡ìx"½˜a´º?5Åg~ó„·=ÃÂ[(Þ>ÕÓI%||êlS¾ðúÅ#<#1“ÓÒœ©ÛaRƶ­-Ì©ôñà/567…~fyß¾XxÛE»Ó¦Xã¼e&så˃µø äØŒ‚Aà׋žd”3ÜL%dµZ;_–]$µZ¯Uutôlý?¿s_ 8Ÿ ÄYlåjr^Ò \ª­&Ó©JMÆK–iZî2ä’H¥8E¯ÀßjÛ>+×µ½KÈé֨ёe…NØÈ ªÀlUûÀ7¨Îkñ¬68ÃŧʷW³}Z½›»Õ/E±þ–gyÝ^)Í«æõc(ûY]FJ*Q’„%ÈåhÅ(·I6¯Í-Üv±ô¬êHéÂR5ãÏ&{Tâ[Eö¬›;!–UqPÙר”Õ-\Ù;Ú¤Ñ1Ýh)+U©lÒ1& RÙ´b<%+š( íJå¨ íJ娗íEÅìÄ1ûSæ¤FÑSR2•"¤°gba)}^¤eµïþVik·½÷¬þÍ?µ‡4‹½oVø?ªµ•¶Íñé—Vz•Ãn`ƒe½¬ÒJü°'j ±ÀŽ˜æô$íÌx•ü=ÍhÅÏØÝy4ßÜÏñV™ñ Àúl:ǾøŸÃºLÓ hïuÝêÆ)&*Ì#W•*ŽBç8R{Þ8úsÒ2Lòkp¦;¹«Q”WvšG7Ä+Òãüê¾·æ+ «ü¬®þ?±lâí?:Oæ‹!ª¾ÉÜhþø·âÝÓÄø[ã=o@ºßö}KGÐo.íçÚì²Xã*Øue8<#¨¬gާg$zx~ÆVŠœ(ɧÖÎß‘ìZìsûVø“û tø_&›¦êžCý³XÕ,­¾Ç›O™<i6ËÇåØXm®Yæ”Uõ¹ïaø0Ÿ+tÒO»Zz«ßÕZþG¹øsþ ŸñwPÔg‹Æ¿¼)¤i"ÑÜè‘Ýj“4Û— ÑH–ê©r[y ¨NI^YæÊÞì_õ÷žîÃê‰þú¬RòMþ|¿™î> ÿ‚bü4Ó~Ïqñ ∼Kw êÏäi±Å¤Ú\[‡È–?ÞÊwáž9£;\ÚWqå©™U—¬{¸N Àг­'6Ÿ¢·n¯îhú¯Ã?²OìÑá-:ãJÓ~ xVêÖišwmzÈkî*ª@–ïÍuL(ù’X“É,EY»¹3èhdø 2µ:1請ûÝÙôMbzA@PF¿®é^Ðu¿k·_fÑ4‹I¯¯.|·“É‚$/#m@Y°ªNqÀ&ª1sj+vgZ´0ôåZ£´b›o²Z³ñ;Pñ-çÇ/‹>'ø©ªÇp4۩žcs¸KþXSawÅ~wÛ ²Jëô—¨SWZþ§ñ߉¼W<ÓQÂVO(­Ýٽݴ»o©ôæ‡pC2àv¯§žÖ? ¡wQͬ2å1šâ”u>š…kÆÇ’ü_øßðëàŽ‡·ãýoì¦ïÍ[>Þ35Ρ"!r‘F?à*]ÊÆ¬è×pÏ;1Ãe”ý¦"V¾ËvíÙ~®ËUv®}W ð^wÇ8·ƒÉ¨óòÛžMò NÉÊOæùb¥6£'ÊÌü øåñ¿Æ?|fþ'ñ3ý›K¶ß“¡C!h4¸ U8ämªd”€\¢¢'å¾q[5­í*i´z%ú¾ï¯¥’ÿ@ü<ðç-àµ`ðKž¬¬êUjÒ©%÷òÅ]¨A6¢›ÕÉÊRòh¡é^$¤~J¡=8¬e#Ò§D½5”¤wÒ¢^H€Ç‹‘èS¥bÒEY¹¤\Hë7#¶"ÒGíPÙÕ e¸âö¨lè2ÚÅSsuÊ@})(—c·ö©¹¢‰!†‹”ŒÄh¸¬@ñûSL–Šr.>´Ñ”‘FEäÕ£žh¢ã­hŽJˆ¥'­ÃPÏ—½o̬ŒÉ{ÖÑ<ÊÚ²÷®ˆžUc2a[Äòk#.aÔVñ<šèî~ÞÁºíœ¨ÆIbITãŒ! çß2Èן›AÊ4æº6¾ÿøcì|=ÅS¥[‡’ÖQŒ—kE´þ~ò·Ì~¼ÁÚF ¬°ÚÙ㺓Gë‡ü[Æš]Ä_&·º:Ö·¤iÚÕ¼èŠ`H,¦šUÛvàåµ( €¤²d© è°ÏKgqnj^×ä~[ü7ƒÍû0Î×Ícu›?mát–›}~ÔU&Õí­âóvZ@‘”sòïoœ²Œ÷ €žËì+ìøO ì°Ž«JómùÙigóOï?š¾yúÌx†r—&œbÓøyåy¹E]ïA7dÛ¶Iž¡áÛ|yh}½$-æ7g´è°ch½høÜdïsÓt«|•$WdóXª‡cN+ª(ðkÈêíbÎoyudt¶ãV±GŸVw5Ö1Š»\•TR)jJi6iH¤ÑD-+š( íSsEÙíEÃMžÔî.A¥)܇2µI™¸‘‘Næn# úS3q#eŠ{‘k&‰H  zW<¢zôkQ~ÁaøcûMø>;é ‡GñtRøbæi¡–VF¸(öëî»]ÃkæBHå±ëçcióRvé©öœ/ŒT±ÑRÚK—ïÛïi#úF¯ý@à¼Qð¯á‡Ž5µoü8ð¿ˆ5X Éy­èöײ¤!™„aäF!;¹ÆXžæ®5'hɣ𶠉’•jQ“]ZOóF¾“à¿h~…¤h^Ñ´Ý'EšK2ÊÂÂ"Ó¦u•^HTÝ–yÁe‘4€ýæÊr“m·¹¤(R§ÆIGk%¦ûvÝýìéªMB€ ( € ( € ( € ( € ( € ( -øßñþOÁ£¹Óa¾ðþ‰y{eý®û-æ¼X›ìп̥¼ÉÌQ„V Å©ÜET#Í$Œ15}…Ôìžýú~'ò] [êž'×/|C®^Üê­íÃÝ\ß^ÊÓMs3±g’I–wf$–$’I'­{Øz\Ìü›9Çû85}^çÕ^ ððy"fO”~µïaé\ü›9ÇòŤϭ‘Ò­¾ÏgMÁéGÝV>.³Uj9¥ÜО¢p´LÙÔž1Z\济rö.¼VrGE)/ñwâv‹ðsÀz׎µ˜~Óöm±ZiË2C%ýËœ$H[ñf 1TG`­·Í̱ôòÌ4±í²Úíì¿W½’nÎÇÛpW bøã:£“á/5ܧg%E^Ri|£¸©NQ‹”y®=ÖÑ»0ãå¯Äç$‘þ aiÊR]Ž’Ü\S>£ ’ÐÓ@+z°EÄ+)3¶œIÇ& éŠKRÉjniÜcÏj–ΈÓ%Ô¶md¡*nj©’ˆê[6TÇ„®Z¦<'µ+š( åûQÌ?f_µÁìÄ1çµ>b]"Šš‘Œ¨•%ƒ¯¬fqÖÃö6üây|â;mql…í‘I-ï4ö”Ä. uÚË»SµÑ™X,‘Æå[nnèÍI/dôó<¨ÏKìí³ïþ~WWGß |K x®Æ­PŠfDFšÛpó­‰$*g*r­ŽÇ‚G5ôtêÆ¬y¢ÏÅñ¸*Ø ®uf¾ç漿§©õg†aÿWÅhrߢG÷(×4Xþåz¶‘;x NÒmÔíâ€;Ø#Æ PÔP@#¥pþ ³Pâ€>~ñ}¸0L1@¿³Ž£gcã¿hO ÇPÕ4ønÒUQå¬vÒ²0cœî&ñ €¶HÀÈÙtP@P@P@P@P@P@P@P@P@P@P@P@P@P@P@|¡ûm\Ø'ìáã[ ËËxgÔ.tÛ{X¦‘Q®eÐJR0NY„qHø;Q@Mwå‘rÅCçù#ÇU£C!Ä6ìß*^o™;.ú&ý> ø{¦Ge¦ØÇ`‹Ç¡<Ÿ×5ú† 0IÂYæ%ÖÄNRwÔ÷½=<¸—k±ÆÈùÈÕ”äxOí ûPøGözÒì#»´þÜñ¶£µìü9or sì4óIµ¼¨Æ)ÚK¸Ú£ #'ÎçyÝ ¢ ™sMíÛNíëeÛM^ÝZý›Âÿ 3_kÏØKØáié:®<Ëš×PŒoyjœ—2Q‹¼Ü#/ÃO‰_•óøˆ¹VqŠ»gëÙ5ZtrèÖ«%E6ÛvI-[mè’[·±ëþW¸’K©D³9‘‚€Xäã5úžŠ¡J4ã´R_qüÄ™LÏ_U%*²”Ú[^M·k¶íw¥Ûõ=ÏÃÖü¡Ç5ëÒGçXú›žÍ£@BEz4ÑñØÊšž“¦Ç÷k®ùÜDŽîÂ,í⺢¼Ž²Ö<q[$yu$oÛçŽ+TqÍ gÙšW%ò©lÖ1%U©lÚ1&U©lÞ0¹2ÇëRÙ´i“ö¨¹º¦.Ïj.?f7Ëö¢äû1­4È•2Oj´ÌeL…’©3 @…–©3DŒÎ¨ÉÄÓ9 •¡M ­s™W6 gЇ¢CæÔäVn'm:¶9Ë«1ÏŒ¢z«½íâ±”ORc“¾²–°”OR…fqš…€;¾ZçœOf…sˆ¿°ûÃmsJ'µB¹Äê8Ýò×4¢{4+œ=õ– +šQ=º5Ž#WÓ÷ÆêAü+š¤.{XLG+Lýÿý†k{¯Ú'ÃZ¯„¼uµ¿Å A^M Åk¶¬J‹¸¡2²°U˜*ùjÒFT¨”EÏbh{i±ûIš¬Ê•§ñÇ?;~}6¶ö>ö®cÛ ( € ( € ( € ( € ( € ( € (óƒþ âíKòԚ5ŒÒ[x«ÄZ~‘xÓ«ŠÞ†ˆ†?›eËYÆ2CŒ2¼ïØò3ºŽ[/´ÒýCð»ÀpìKhÕyÀɯ£Â«Xü[<Ÿ3“>ÉðE "´ví_A†‰øþuZ×>ºðu¤abFkÜ¢¬Ë39Ês±êbЧGÏÔU:—1X^N¤„»H…/2ä´³Fl¸Rx­ÑçOGcõF Ǥ‡N]Ä_Û«Çz—ˆþ2É•£øFÚ8 L«y³\ÅòË¡†U¡i,“¸cyùgc'[õwðÓZz´›’¶»_©ýíôváÊg ,Ú.õq’nOUhÓ”©Æ;´ìÔåÌ”[çåwåLùÀµñ“gô¾F½ºãµsÍžÎ4£95ÎÏRšî[SY³¶,”jM¢®N«RÙ¼bYEö¬Û:¡u-‰(Z“eUZ–Í£uJ››FÂTÜÑ@z§ ¥rÔ <ºW4äBytî.D/—EÑ´x§r2»ÇžÕJG<éÜ¥%¸ Ö±Ž ¸dÍŸxÃSøoâ«_éPG1`¹¶—\ÀÅK&ì§*¤0èTd•>Ž*.èøÌû ¥˜Óp–lû?Õy~Gë§Áÿ蟼;iâ= ¤[I$x^ ‚‚hdUf HÚÀg;]Ozú*UcZ<ñ?ÇàjåÕÝ Û«m{;öº^ž©ŸOh’’´8Ï^Ñ|”ëC“Šõ- ¯É@²ôJZ( cÄDg=q@=ø¶DXg8(ìëi¥Þx·Ç£EbÂÒÚÞ9°Ù ï#8Û§sZÇÉ8#' \Ð@P@P@P@P@P@P@P@P@P@P@P@P@P@P@ð×íù—á?‚CŶÍÿ’wµìäjø§éú£óoäã‘Æßóñé3>Qðž}œ9<¨úNÞ'ñyJ®Æ'íñòÏà'€\‚Ê CÅz¤¦ÏHÓg•UZM¥šyWpv†1·vÎKkm¹æ‚Z0î¡ëTŒäŒI“ªFFTíZ9æfÊ+HœU'zÚ'TgËÒµ‰æÕ3%ï[Äò«#6nõÑÊ®eË[Äòk³w­âyuŽŸáøW×î Ã4³ZºÇ ³¶ål߀OÐãÍŸ.Iìš¿âtdE–pÆ&®77«ìè¸8órÊJîQµùSjöÝé{+Ý£°Õ¼/â–³h·lOÝ‘šòècðз5E÷œÙ·‰ü%‰¿±Ç'ÿnÏÿ‘?Mÿà–ÿ|û9Éñݾ2ê×^"þÅþÍÿ‰eåïÚ|·ù¿ñï›vùñ}ìgwÁǵC;Ëà½êÈüÇ5âü“5*X”÷èÿT|l¼-áïüCÐü y¨ø&ËU¾±Ñïµ)=ÕŠÎñÁ, ¢íÆ`Q9'å^àãVcKÙËÝmI>é{ßÔs<Þ48 ŽŠçS¥e­¿‹h_g·?5ºÚ×W¹ë¾‡ˆÇl×é´QüM˜OsÞ<=CŽ+Ó¤‡Ì'Ðö &/•8¯Bš>G-Yèúl\/×|î"Gsaºb¼Ž®Ö<àVñG›U›q QÒ¯c•»–W¥"â‰Tt©fÑE”\Öm0ËJ• ¦XXꎘÒ,,'kK«ÿj[\k×ße¾hImÖfX|·É1 L Wâ½_o­5.då+;ßKégÚÖ·‘þ¤øy—ÿeðÆY…•e(Ð¥Í^V¦àœù£ei9¹9]_™¶õ¹ÅAÚ¼iŸ¤á͈x¹å©íQVEä‹;à‹H+6uÁ\²‚¡pE”\ÖmP‰eV¡³ª,*Ô6tF$¡jMãeZ–Í£e\ð*[6ŒI„b‘ª‰(JW-@”GÅIj"yJ.åûÑqòÑÓL—»Åž”Ó2•2«ÇùÕ¦sN™Ÿq`r+hNÇ›‰Ãó#¾ø3ñUøYãÝT·Õ>Ëá뻘`Öa–7–)m €îc^KƬ̌¿09«2·«ƒÄºSZè÷>ˆòHcðòJ7©Ü}{|ÏÝO ê6Z…¥–¡§ÞCscsMͼ‚Hæ€*ÈÆR Ž5ôI¦®Æeã%feÑg_“šdž±¤\¯ËÍz~“t>^hÐmfÆ9äPš(¬ÊŠYŽ >ñ 0ãFý¶¼85¿÷©½ò?áÕ¬õ//ËßöÌÖ›3‘·kßœ¹Œs‘êäµ91i[t×ëúŸø™„úÏÔ©Íog(Ëmîù-åñ_®Öësó^ø¿ üð ÏŒuËYïºÚÙiöù ytÊÌ‘—Á®™œôU8 ÛU¾ãšÒÊ0¯U_¢]ßE~›jûwvOùg‡x â&} Ÿ% ç7´)¦”¥Ëtäï$£¼š»Œy¥È¿ˆ_¼[ñcÅ·þ3ñž¡öVç Q‚°ÙB ) IÙäàd’K3ff?æY•|ʼ±‡vþä».ÉÁwm³ýàž Ê¸#*¥”eùiÇVÞ²œ¯9».iJÊîÉ$”b£Æ+˜Š 1ÅyR‘÷ÔhØÐŽ:ÅÈôiR/Gµe)…*EäÚ²lï§Lµ~Õ›gd)—cÚ³lì„ ±Å’8¨lèŒ ( ç¥KgD`jÅmœ dÔ6o›V¶9Á+ÍKfª'MiaÓåæ‘¢‰»™Ð²Ò¹¢Fœzxþí+ŽÅÁaòýÚÆuÍ €¼Ð&Žfî¹8ª%£šº‹¯̤Žnå:Õ£s©Õ£–fdµ¢8ê#>AÖµ‰çÕFlÕ´O2²±›/zÞ'—XÌ›ø«¢“XÌ–·‰åV3&­âyU_ý›´¤Ö¾7x+Lt³}³*{âÒvþ•óœm]á²EUºäÿÒâÈ|^ÄK ÂÚÑÝ{?Æ­4~­®µÿŸ4ü«ùÿûn§v¬U¿™‡ü*ë_ùóOÊíºØ¬U¿™Ÿ üOðuÏ„>0ë¶?`ŽÒÂú/­–=¸™]ð͹Ï$‚{‚ |1ÅÇ5ÃѨæÜ©©§¾÷ÑkÑFJÖò]?°8w‹^càíp©í'í½…NnkÇ–R«›µíI+sEEòèÖŸ‡àÈ„é_·RGâXùî{¾ƒ W§I Ž–ç­iQŒ%w@ùLT·=LNW\óØ–w61ð+¦(ñ+KS§µpq[#Ï©«5ÐîMÜÅ+ÍK5Š'Aš†ÎˆFåØÓÚ²“;©@º‰íY¶wÓv8«)Hî¥D¸°ñY9Ñ£ ÿ'4¹ Žò¥.b¾®G$ÕJFU(ÞjÑHâ©BÅW‹Ú´R9'H¦ñãµh¤qT¥b«¥h™Ç8™+DÎYÀ€Š³ˆØph2h£:ä ‰‘=¾àN*:!;hs÷6¹Ï“Gu:‡5wiœñXÊ'£J©Ì^Ùu8¬eÓ£Xä/¬sž+ Dõ¨W±Ç_Ø}î+žQ=zÎQ°7Ë\Ó‰íáëœ>£cÃ|¼×4â{xzçk9Ýòðz×%HŸC„®~ÉÁ7h;ÏøgPøâ‡ß®x>È]è÷¯,óK{¦J¼rSìÏ, 3‘¢Æ,ÍóØêÎ\ëf~Ù¯Öè}ZžkþÞ–ì~ ×õ¡@P@P@P@P@P@P@‚ŸðV j6?þøòi­[GÖ<=&‘*ÌfY¬îdšVq·hBº„!HbIWȽ è|‡ÓjÕ:5o¹ÿÁ>CðÆëU†+é°º£ðÌõ´ÝÞ‡Ö¾OõUìÒ¹ùÆaË©õ„S,ûW£M»Œ\~²ðžût¼¼—tl2±ÅßêkΫ˜ÚN_yöXç¡V*w‹ÙGõäQÔ­Ò1Å¢Àb¶¡7'y;ž~i†…:t⢑ÁݩֽXjÏñ)ÆMûCxâO†<}ãKI'Q±°hìæ·Š9Z¹™`Ê¿ÊUe–6lçå†û§8ż­xî–›nôO]7jþ]ϧðã‡ãÅ\W€Êj¤áRiÍ6ÒtàœêFñÕ9B2QµµkUºþr!a_ˆÌÿQh+ÉÖëÒ¹&Ï¡ÃDÔA\ìõ ‹±ƒYH_r+ÏF” h½«6ÎØ@¶‹Y¶uÂ%…Z†Î˜@R¥³¢0,*{T6tÆëKfÊ˵MÍcÂÅžÕ75P&XI¥rÔK o“Ò•ËP$û)ÿ"‹>ÍZ.¤Mn})ÜN ô§r RÃ׊¤ÎyÓ(KA­h™ÇRÑuo¸k¦±âb°üÈý=ýŠþ*6½á;¯‡º½æísÃx6žl™yìü¸Üå›Ê|Æpª¨ŽM}6__ÚÓå{£ñ/ÊÞ íâ­þ}zuß»wgèÖ‹{÷>jï>Hõ}"ýp™jô3Qn€;Û X(_›šé¢Õ"`7š‘õ8{Ð9©k`£ÀP•ëºÊí}ÏÅ|ïâ9u?êö>Ñ#óµ]Fu¶·B”3n}ŠÌ#Q–v vª³ ½<1áÝ7Â^Ò|7¤¡6ˆ•ÙQ^fêÒ>ÅU2;v ³1Ç4»@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P€þÔ>ü+øñ_ø•â?ì} ûM¹Ò¡hb7—7È‘Ákdó¦o˜„ܪ‘ÝjÖqªþËOî1Åeu3¬5l¾›³«Fö½¹“Wéµï¿‘ü‹ü@ø‰â/‰ºÔzž·)ŽÂØ4vllLVQœdï;`r2ÄŠª«çæ¹­lʯ=M"¶]ÿ>ﯥ‘õüÀ9w`~­ƒ\Õ'gR£^ôä¿(«µÞÑMï')K“Šœq^,¤~™F‰£^ÕŒ¤zt©ã‹¥bäz4è—?jÉÈî§H¸‘æ³lì…2âGPÙÕb„š†Î¸@Ô‚ ㊆ÍãfÞ×v0*7Œ–ÏLvÁÛRl¢u–z9ã"•ÍN¶ÇEf ÇÒ‘v±·ŒÿÝ zhÍýÓùP= &Ó6&6Ð3{hÊO £“¾·Â¶E†Ž"ý6“éTe#•ºêjÑ„ŒƒÍZ9fŒ‰kTqÔ3äïZÄó꙲÷­¢y•ŒÉ{Öñ<ªÆlßÅ]<šÆdµ¼O&³2åï[ÄòëxÿÁ7ôW×~:x®Î4ÜSÂwRc—–Cú×ÊqÆæu:Im4ÿòY/Ôü?Æ|ºY¦IFŒUíZ/ÿ$¨¿SöÃþÍÏüûþ•ùWú³?å?š?Õ ¿Êð®nçßô£ýZŸò‡ú¡WùOÎÛCá̾ñ×+µšœZé‰ãUz›öçoQZ#Žjû‘ÕM3=z–Pf¥›A#ZÎLí§ôkXÉž…(—£NœVRg¡J”)ÓŠÆLôèÀÐH²8‹‘éB•Ñ2ÃíPäožG|Rç4ú¹ÁíMHÎ¥£ÁíZ)œU0å !#¬ª |Ž5û*÷?¡øfšÇeŠR9{Oåæ»°•¯c帇-TÓÐò}N’‘Šú2¼Odz:έ„¿ooØè_³¿ˆ4˸§yüA¨XéÖ­©XåY…Ñ2dŒ/—k Èî*1‚Hðø®¼ies„¾ÛŠ^·æ×åó?Qú?eU±Üu‡ÄRi,<*Ô•ïwJѲw|Õbõ²åO[Ù?ÂËaÎM~IPÿC°©^æä8¥rÏCßÃÞZ#b$é\ÒgµJèÓ¥bÙèÒ¡ñX¶zTá¡q¥fÙÛN¥Zͳ®,*Ô6tÂ%”J†ÎˆÀ²‰RÙÑ–:–Í£Ôqf¥³XÄ¿¾W¥MÍT oíEÊQ.ÃlOj–ËQ-µ§N(¹\¤FÕ½(¸¹Dk\®1EÔ£-¶2æšd8™SCŒñV™Œ£s6X°iœ³¦dÍ^+hÈókÒ:¿†><½ø]ãÿøÎÐÊÖ¶ÒyWöÐî&êÑø•6†PÌÎŽß1ž•èà±>Æ¢}‹â|™fxISKÞÝz­»ú?#÷#Â>,Óõí'I×4›¯?KÔ-㺶›k'™ŠkFTƒ‚ëê“RWGà•)Ê”Ý9«4ìýQìN­÷~jd§k*üüÐeg¬ðúÛ‹]éóÐe×óütËê^!T ZOÖ€¾ € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € (†«ªéz—©kzÞ¥k§èº|]]ßßL°AkjYä’F!QAbÄ€$ÐݵcŒ\šI]³ùOý½ÿj“ûQü_ á«¿;ᄼÛ? ù–?ešãÌX¾Õu&âd>l®ÀÛ6ÅY$2îò1Uùåe²?CȲ¯ªÓæš÷å¿è¿ÏÏä|Y 8"¼éLû*,µ4£‹§„¤z”©㌠VNG£N‘u²lî…2ÜqÖm”é—c޳lë„ ÐÜqPÙÑšðÛð8¨léŒM«kBÄqRÙ¼buún’\©ÛSshÄô-?Fá~J›š(¦Ÿ¡+òqHµ¾°ðöîv¦‰›±«ƒƒ÷)ØÏ˜°Ú@A”Xi˜×ÚnÕÎÚ“hœN£`bE0hóV9v5eÖI~¡ù7‰¹œ2¬²iìê%ÿ’Íþ‡ïWü,»/ùçýò+âÖŠ]‘ø‡úçC²ûÂ˲ÿžqß"õ¢—dëËîGåíÙãkÿüQðVnèzn†.mí–4_.yî%YŸpŽå··$³€2Ùý_€1tó \L¼ü¿tS_úS6y¬s\?µ…¬›Zz/ó>wðäy=Å~“Dù,ÆG¸èIŸ, ô©Ž{ž·¤Æ>Z璉ųÐtôûµÕÀÄ3´³^tDñ곢ёZØã“w.(À¤8êXAPΈ"ôb²‘ßI0§JÆLôèÂæ´1çÍ)Í W4¡‡§„¤z´(\׆Ümé\ò™íQÃh[[aéY9qÃ"amÇJžse…¹–¾ÕQ¨E\!FKlv­UCÏ©…±B[~¼VÑ™çVÃ3@Aé]™ã×ÃØÎ’.µ´dy•iòÇ׊Ú2<Ê´ŠL•ªg àVu­9g¹g;ˆÆàÓLÍ«Ó@}i4\gcæ¼Vmtæs·Výx¬¤ŽúUfòÛ9â±’=:5Vöׯ„¢z”jœeýŸÞâ¹åØ¡Tâï첊çœOb…k§cÜW,â{¸jçjÖWúW$à}½š?\?à™_§Õüâÿƒ:µÍ°ŸÂ“ GGFš%–K+§v™¡™"¸Ë´¥Ÿ›ÔC´æó<“S]OÚ¸30úÎXi=a·£ÿ'×ÎÇê%yÇÙ…P@P@P@P@P@P‘üyø½¡üø?ãÿ‹¾!‡í°kˆì÷:}¶é™b¶·Þ‰!ÍžHbó O3s|ªML¤¢®Í(Òuª*qê!ßÄo|Wø¡ã/‰Þ7¹óüIâAõ¢’JñÛåˆH!óÝa‰ Å;#U–Wæ¯(>ªÿwü9—e.†WG¹dãko̯{ùröÖÿÔÿ [cdlŒ+í°¶?—øƒší3ëŸ Íþ«Ò½Ú ü«4†çÒÞ“">kÕ¤®ÇIÆV>°ð¶µ…‚³0ÜF¯˜Çá]j–Gî\#žÃ/Á©IêÑ>£©Û_1‚{ÔÑ¡:'FgšÐÌÒÌòÝr²nǽì,®Ésú<•9Ìÿø)"ãà…ìk¶ÿÒ;ÚðxËþEðÿÿÒd~³ôiÿ’¿ÿ`ÓÿÓ´OÅÛQ“_–Ô?¼°jìémÓWÙõ8jvF¬IÒ¹¤Ï^” ñ¥c&zT©šµ“g£N¤SY¶uÂ%”\â³lë„KH• Qm#¨lèŒKIKfñ‰m!oîñHÕDЊ,ã+RÙ¢F”PÐT¶j¢_ŠÍ¿¸i\µN+Fã**E(—Å‘ |œ}(*ÿ³ò1²‹‡)^M=—?)Åå3¥²È#Éq0n¬Š@¦™”¢aÏŽjÓ0œL{ˆÆÖ±g jwF4è °"·ƒÔò1Ó‹?Bÿcÿˆ1ÉàkÏ ÜMÜè®(ÑÔýžviU™ÊXÈg.0r;Ÿ«ËªsÑK±ø`ž2•N“׿·ü,}ã¥xŽ7 ²AôÍwŸ&wÚˆ>ïÏúÐWoâ` 'ë@‹â«“%PŸÅØÏïZó¯øî Xä–âéQvjõƒ_.>#½ŽüwdÉàŸ–m;F¹\gºÍ:ŸùvèUúÞ§÷X€}Ý@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@ŠßðUÚÎçÚt³ÃíZêÛ^Õ`ŽóÅz–wXH²Ó.dW˜l–@L¹1¯ï#¸p¼8Êü‹‘SÙ_Ö'õš‹E·¯—çè~ [À8¯r¹úV…H£é\ò‘ëR¤_Ž:ɳѧL»{VMôé—#޳lì„,]Ž?jͳ®/Ãâ=*:¡fÞß§ ½kf\Ž*7ŒN×KÑË•;i7cdFÒtC•ù8©5Hô7EÎß’‚ö;Ý7G(W÷cò¦£s Öp;»=0lûŸ¥h rÏ™y´Àáiò,B¹™5¦Ì†OÆ¡«0¨™ÏêªTüµ P•Ï7Ö­Šïx¤<‹Yˆ©~)™3ÍuÉg=ª‘”Ž6ýyj¤sÈå®zѳ2eíZDâ¨gIÞ¶‰çÕ3f­¢yuÙ™1®ˆžMffMÞ·‰ä×fd¦·‰åVf\Ýë¢'•]ÜûWö»Ò´xûÅwWRE¨ÛØÁ§Âžb¬mò4’d°6Ñc dŒ~mâmLL°Øl5îÊR“vw¼RKåï;éÑm­ÿ™¾8œl°˜.IÎs“³½à”b–¶³U%{¦î•š³¿éü-{ùýþþ ü{ê¸ß?¸þ`ú–cç÷ü-{ùýþþ >«óûƒêYŸÜ|‰ñÓ_‹Ä¿4Ëøe*iQC•lò&œÿìÕý'àÝ:´òJʶþÚ_úE3ôž§ZŽW8×ßýܱ*ør<,gÖ¿i¤Œ³jÏmðú¯éRGÅãÙëZRãoÝå1Lô=9xS]P>ÎÊÐpµÑɪoDë9œu-¯jL¸–PT3¦š4"^•Œ™éQ‰« ô®y3ס^é\Óg·‡‰µoqÅsNG¹‡§sj¸W,¤{´(è^Xk#ÐÊÁíPætÇ$–þÔÔÅS P–ßÚµŒÏ>®Κ¼fy•°æ5Äž+¦^v?¦Ý7RÓµ:ÃWÒ/í¯´›èRæÖöÎUš˜]C$‘º’¬Œ¤ÀAWÌ´Ó³?sŒ”Ò”]Ó.ÒP@P@P@P@P@P@‚_ðXŸŽºf¯ðÿömÑÖêëJ¸OëÓ¡YÊs°ÙÛ†YrŽbšâY#’0vKjêØfQF<§Òpö Ö«í^Û_×sñ›KˆÃ$r ŒzWì±pofí÷è¿UŹ3Çðö*1KšçMôä÷¥m›Š’^¶m&Ï­~ÞfHWw ½+ô¼â.$££gؾ¸Ûåä׿AŸ‘æp½Ï¦|%v¤ÅÏ\ õè3ó¬Ò ^ÇÔ>/í’7°f¼ŒÂN”ÛGè¼!B†0’»;qáèvîdÀ¯/ë’½“>õpÝ.[ÉXâõÍ1LLê¿($ ôðµÝìφ⠩:nQZ#ð?þ ñ’ÃÆ~=Ó~øvißLðdÒJâ+Å{kËù?”F„ÖàIf;•ä™6®Ò_ä8³5Ž*¬p´Þ”ï}tmÛ§÷vïvÖ£>¼W"Ëê縤½¦-EA8µ8S‹–¼Í'j®Ò²÷\cNWwJ?Ú[m!«â*NúÔx“L׊>œW<™ìѦhGc&zT©—+&ÎÚp-¢{Vm°eÒ¡³¦.ÇåPÙÓ–Ò<öü*[7ŒM-É95-›Æ&Ä6ÇŽ*5P4á³ÜGËÍ+š(Ž”XŒ­#Ez- ‚>ZW+”׃GÎ>JW*ÆÒh@Ä>JaŸØdb tnÅh ½ö’cbT~îCG/}d@9^i‘(œuÕ¾ÖäX’=èß4«¸0Š÷Ú( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ùëö¦øï¦þÎ?ümñ>éí_[µƒìš…ÑVú¤¹[xü³$m"̲¬lC̹ÛYÕ¨©Aɘ ±ØˆÑ]ü—_øv?‘oxÏÅÿü]¯xóǺõÖµâýjss}©^¾gÀTEP¨ˆ ""ª¨UPÏÕ¨æÛgë¸ 0ÔãNš²FT1ô®YH÷¨Ò4b§Œ™éR¦^+&ÏB2Ú%fÙÙc޳lë„ ðÂN8¨lê„ ‹{~œT6tF'Agh]€¡³xÄï´­ÍQòóÚ¥³eдmF*6b‘ª‰ëš'‡Ù¶e(Já9ªjìôÝ;Ãåvüœ}+eJçSÊ÷;«i5±ÞgQ‰¶,„æ·Tô<Ùc/-HΟ€A^ir”±%å€PIœ¢vѯs…Õ"ØHÇÍ5cÚÃ˘ó=q~ýdŽÆxÖº¸ßTfÏ*Ôz¿5HÆG~ØÝÍZ9¤rÓœšÑµ“5hŽ*ŒÎ—½kΪfÌkxž]c2ZÞ'•XÌ—½tDò«r÷­ây5ŒÉûÖñ<šçQá7šÚÖþæ ‡C, ¡+÷FsœÿµúW`£9ÆW²üÿá_"ÈòüÇR¾:„*ûÖJpŒ¹l®ÚrN׺½­²ß¢jšÖ­ï/T»_÷gqýhÃáhËx/¹Fmdԯɂ¤½)Á~‡ö ðÿöRø!àÿø'ÂZçÂÿxZÑ4‹=:óÄ7Þ²êÓà G%Ì›•Û|¬¥Ûs±Ë³O¶°T­ì£ÿ€¯ò?1ž]‚”›T ¯ýÕþGâíá¿øOö¨ø§áÿ hZv Z6›ö}7JµŽÖÞ Úm£¶È\»3KÔšúlª:4¥Ûz+~Gå[NqÕ!N)%m²Ùg‡劾†‰ùnbõg·è+€¸¯J‘ñxç¹êúJä-wS>WÏAÓÔ`bº x8†v‹À¼O*£ÔØŽ.œÕØÇœºƒ™QÔ¹äVr:é-M8{V=jÖ…sŠç›=z¹µoqÅrÍžö™¹oãŠäœ ÃSfý¼DÅqÎGÑaé6á>•‹‘éÓ¢ËɵdæwÓÃÜY-Î:P¦UL3¶Å -úäV±™çUÃÓ[px­£3̯…ÐÆžÏÕ ž#cOçŠé„χ1'‹ñ]p‘àb(Ù™’ÇÖ·‹<š´Ìéc­¢Ï6­2‹¯ZÕ3ÏœJì1Z&sI°¦c$@èJvÌ{¨ù5GE9íÔ=x¬¤ŽúS9»¸Nb±’= S9[Û~¼V2G«F¡Çß[õâ¹äZ…CŠÔ­rŠçœOgTà5L†®IÄ÷°õO0×´ýñÈ6ò+ެt>›_•£ö‹þ ÁñRïÆŸ5/ëZŸÚµßÞ‹8RA;ʺ\Ê^×Ì•ÉVÚëu *+x×h-òØú^έÖÌýã„óÀòIÞPvë·OÕy$кâ> ( € ( € ( € ( € ( € (‚ø¥ñ#ÂÿþøËâwŒî¼ xnÂ[û¯I>ÑòC˜è4®R(аß$ˆ å…&ÔUÙtéʬÔ#»?x÷ž!øÃâ.¾Ñâß˨]my^87Ÿ’|ÇwXb@‘F…ŽÈãE +ÁÅUæmŸ«ä9z£N1H[ L€¯*UåNjqz§uò?@£–RÆá熯Óœ\dµWRVjêÍ]>Žçµü:»h¦ bh›z×êùf&šq«Mèõþ¼ÖÏÌÿ?¸ç$Äd¸Úù~.66â÷³ìÕÒ|²VqvW‹O©öW†¯²" úWÓQ‘øneCsèïê?¼·»Šõ¨OSóÜÖ‡ºÏ±<¨Çn±;7¦ræt]KØ÷ø1†—êmŠòèr„oÇA_-*R¥-OÞ(ãif¯ωÿnÏMû;|›RЯm¢ø‘â+¦è1L‘Lbo½=Ñ…ÜH£È ÔK,Ô«‘\øÌÊX:nTß¼ô_çòüì{<7Á4x‹XÈ·B>ôíu~ѺZs=õO•JÍ4æ&Î-äqÅ|5YXþ©ÀÑuÑCÀ⸥#é¨Ò±­]+žr=Œ=#Z8ñŠæ“=šTì_òЧnHå`ÝFzŽüôíÒ²æ¹èªN›³¶ÉèÓÝ_§^ëtôvi¢Â%CgL \DÏÒ³lì„ ±ÇÓŠ†Î˜@º‘Ô\èŒM!ŒŽ*[5ŒMû[PØ dT¶moAgÀâ¤Õ#£°ÒËJÒ¹iÆŸ¥}Ü-#DŽš'îPRFý®‡Óä gC…˜ÈÙ@ô ƒîs@neO£cø) #Õ4rÀLþÄÑçÚ®˜Ê¶t¦™›GßÚòÜUÉ}ôgЏ³–¤NfxúŠÞ,ó+@Ç7Ú–‰§ëz.£s§ë:|ñÝZ_ÙLÐÍk4l$ŽE!‘Õ€`À‚Wnn2M/œá¡R””ÕÓ?°O èÖ_þü3¿øÛðçE»×oô;XÔ|=®éH´ÍNKU2ªÛ܇hž6–hÀlº‚ÊNsŸ±ƒn)½ÏæüL!N´áMÞ)´Ÿu}ª~Ëÿ³ö­¨hœ¿ 4Kc=´zDM†F,‹ˆmÊGr¹~I•׆0ì ‡ü)¯„Çü*ŸcÓû ÓÿФÐ@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@ü±ÿÁD¿iËOÚ;ãTzO…¤ßðßÀjÒ4»…–Þxõ;–—WÐÉ9†_&Œyަ8A°Êè<|m~yr­‘úG eo KÚÍ{Ò×Ñt_×{t>†.œW—)uB•8£éÅa)­*eäN•‹g¡NÄJͳ¶œ ±ÇY¶vB„0îíPÙÓ›Vöý8¨lèŒMÛKR욆ΈÄî´(’¤­Kfщë:&Â|´”OYÑ4%gRWö¤“Jq‚Ôö]BA³ä®štÏ‹=ÃDO—䮸Ó>z¾,ë­t”@¿%n yu1Mõ7MO(ü•§&‡Ä>mÌK½9$-g(´± œN©€ÃÒ¹¦k 6y¦³!½k’¢>‹ &y.¼†Ï¥s­ÏUž%â 9’¨ÍžM¨·-Ta#‰¾'æ«G<ÎfsÖ´G%C.ZÑU é;ÖÑ<ú¦lÕ´O.±™/S[Äò«“w®ˆžMvfLkxžMfeNx5ÑÈÄ3®Ð£X´d‘I̬îÙìs·ÁEy¸¹9Wkµ¿Ìû>§9TfŸÆäß­ùtùEC~Ç? ô¯‹ÿµÁ?kmjÚ,ú¿öåµõ’ÞÁ{”R_Im$,B²L¶ÆÝ¤•p6ŸC É#ĘgJn;ÿž‡ö^ÁùÉüåþÛÀÃ_|^ÿ{KÿÓ]}]ü%óüÏÇøËþF5?íßý%iáᄎ½êGå9†ìöýeP×£Hø¬~ìõ$pµÝLùlQßiãî×Tv6ƒîÖñ<ª†âtZ¶s­É×­K7‰n>Õ”ŽÊF¤=« ­l[¯Jæ›=Ü4N†Ùzq\sgÑábtËÓŠã›>“ ¡¶NqMŸK…††œiX6z´à^Š<ⲓ= TîJñqÒ¥HÚ¥- 2Å׊Ö2<ú´ŠÃÁ­£#έGCâ¼WT$x8š%Ä=kª< M W0õâºá#çñ4LI¢Ækª2<*ô¬fÊkx³Ê­:E­“<Ê*:÷­Ç8•ÈíZ#žHŒŽÔÓ2h£qrhh¨JÆ Ì9ŠÊHì§#º‡¯”‘ßJg3w^+#Ò¥3”½¶ëÅa$z´jv¡k÷¸®yDõèU8=FÔ|ÜW4â{˜z§œë6£çã­qÔ‰ôX:»@þÁ_OÃÏÚ7Nðýõç‘ xÖÒ]U¸Ô>Ín—c÷Ö²2–YKÆÖñ©Ãfð…9%ÁÌésSæ]Ö¸0öX¿c'¤Õ·²¾ëÕô^§ïíxë@P@P@P@P@P@_ðYˆ¿ØŸ>ü0µºÕ-ïü]¯½üßd“eµÕ•„_¼†ã æ{Ë)Q ²îƒq*È™åÅO–=̇í±]—âÿ¦?z]¹p+çëÌýƒ)ýGÒ¬Œ¬ˆ ¯"¤õ?DÀáís¬6ÓxwRÓ®Á Òž9,¸ÏèËú×Üð–1ÎŒ¨¿°ÿÿ?¿îþUúCpÜ0ùÊ %ˆƒOVÛ;&Úz%É*iYý–ÚOWõ?‚õdº³‚eppkôŒ<î®g8WJ£‹GÑ^Õ–­ƒê+Ö£=Oϳ<6´}=á}Rà,DÎÄzì’mjÏš£(F~älÏ¡<9¨JDdÉÅx¸ÊQ}Ó8sV )HþkÿmÚNûöšøÁu«ÙI³áW‡mâ–sŸ•‹^´rÙ5ÇÈÌ!ÆÛŒ[Ûó<ëÕn? Ûüþg÷ä2ʰ0§Wø²³žÚ;|7WºŽÛ»»µdì|ÏiÅ׋RwgéØÿ‚…~Ñ?ðÏÿ³î¸4-Sì¿üe¿Bм‰ü»‹mëþ“x›eŽTòa'lÑîòç–ÛpÃW>&¯²†›³×É0_Å%%îÇWú/›éÚçò±kâ¾~¤Ø0”lˆ£®Y3Û£LÑ+ÏJœ ‘¥fÙÝNØÓ½fÙÙ—¢$qPÙÕ›VÐŽ8¨lèŒMûh7T6oΑ¥‡*H©nÆñGªhÚ2’œT›E·¢hü'ÉúRJã”Ôëz&‘‚Ÿ-tSäâ±[žË¡é?så®êp>[Šk©è–ZOÝùkª0>~¶(é¢Òr€íæ·TÏ6x½IZÇËŒ†r’«ó3š¾·úV2G£B¡æzí¾Òäc5ÇUK©{M¬7k†gÔá^Ç‘xƒn‘Ò¹Öç¯ÐðŸlCº¨ÊG’ê ó5QŒŽ>ðŒ5Z9¤sSžMhŽJŒË”Ö¨â¨Ìé kΪÌÙoË®ÌÉkxžMc.cÖº"yUŒÉ»Öñ<ªÆMÁà×DôglìZm­¶Íޱëœá'Ÿ©5å·íjÊ~gÞ*QÀRÃÚÍE]o«Ö]úß˶‡êÇü×á×ü$?¾%üMºµÒ®,—®tV«Ò¸ª3é°‘:;U⸪3éðÐÕŠ<×<™ìR¦iEN+ Hõ(Ò'’.*ŽŠ”´)Iµj¤pT¢R’¬dpÕ¡¡q^+ª<Ï EDiÞ°ñœÚV£h$ÁWN&ìè{0ÏÓ¨9ƒxLel eZ‹³_s]Ÿ—ü:Ôäâ˸§.©–æpæ§-SÚQ’ÚQzÚK¦é¦ã$âÚ~q¤ÿÂCðÿ_“þ#·h.“ §$Çq?,‘·ñ)ÁÁê €AöL§2§Œ¤ªÒwOïO³óÿ‡ZæÇˆáÜmL>µ#ªkXÊ=%¥âþM;¦”“Kê?ë 4‘:¾Tãõ8z—?ÍðŽ ¦«¼+ª'—géÚ½dù£¡ùäâ¨Vn[)~Ü_µ\þð­ÇÁ_ßXÍâ/ÙÍo¯Íþ¶M.ÂT äì*PI:;Œ“¹#‚ƒ$r/Æñ.d°Ñú¥&œ¤½ï$úz¿½.š¦Jx!ÁSΫ. ÇBQ¡JKÙ-•I¦ï+Þî4Ú[.YKNorq޶6ùÃ8¯Î*Ï¡ý©€ÃÞÍ££‚.•Å9OB‰« ]8®iHö(Q4£‹g©N‹¨•“gu8c޳lì„ ˆ•›g\ ^Š<㊆ΘÄÖ‚ÜœT¶tF'AiiÈ㚆ͣª³²ÎÞ)\Õ#³Ó4¢åIZ“DIÒô•~JF‰Þ¢–ÛòQ¸ÛQÕž‹¤ø;r•´)žf+edz §‡øSåþ•Ô©žLežçIkáücä«TÎycmÔ݇@ùOÉúUªG$ñúîW—CŸ’“¦io™ËêZX@Ãma8žsÌõ½<üW;f\ñ  E“Žk6uSw<Äm•Æ(ELòÍLmÜ;UÄä¨qw#“[Dó«lrú’æ'Æ»h=OšÍ#zlþ̾ø×þOÃ?‡³?³¿á)Ь5¯ìÿ;Ïû'Úmã›Êó6®ý¾fÝÛW8ÎJûHKž*]Ïæ\M«Öß•µGcºª1 ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( €?•Ÿø)Å+Š¿µ—cÓ嵟Fð\øNÖâÞ aw{fwºYDŸyÒò{¸Ã(T)»ï·‰Ž©ÍQ¥ÓCôþÁ:88ÊKY{ß~ß‚Lø–ðåÊGÝÐ¥diF•„™êRy²lô)À¹Vm‰~4¬Û:áJ³Š†Î˜Äݵ‡$ T6tEv›fY—"¤Þ(õ=Çî µ&±G°èZ^ý˜^)>Æ¿ ¹í:Â|•ÑN'‘Œ¯m^Ñt^Sä®ÈS>gŒµõ=ƒDÑÀ •®útÏ”ÆâüÎîÛGèTs]*™áÔÅ›1ØlBVŠ'«ÝèeßÁˆÚ¢KCª„õ<óRÜ…½+’gÐa­#Ëuù~ÿ5ÅUŸO€†Ç‰ëÓ•/ƒ\3gÖaãd™ã~!»áù¬O¡áºì¥‹’i£)a'-VŒ$r7Ö­Òg?1ëZ#’£3%=kDqTf|½ëhžuVfÍÞ¶‰åÖfdµÑɬÌÉ{Öñ<ªÆdÇ­oʬÌåg¹·É $Š„¯\Ž+fÜ äº#Ì8â1èËiI'èÝŽ»S—¹æ¼ê>Ï5­kŸÔ—ü/áEÇÂÏÙ+Áw:”7Pk^7¸›Å·V÷Ã2"\ªGjÑþê=”’•bÎG ´ü‹ôT!ÉÆó\GÖ1R’Ùiý|ÏÐ ØóÂÿø)oüœO„?ìN´ÿÒëê÷2¿á¿_Ñ–qçûÜ?À¿9+xs"¯¢¤~3˜îÏnÐOÊ•éS>/¹êºOð×l—Åý‡ÝZê‰à×:ûNÕ¼O*¦æÔj8ª1M–­&mä|ÖR;i¶ã‘\ó=|1¹oÔW,Ï Ðè­Jâ¨}> %¨é\5§Â#¥µ â¨}VhlÂ:W,n‚5!¹äzôR,ºŒT&uÎ(ªêµ¢gH¢œˆ0kH³Š¤F=Ìcšé„MWŽx®¸HùìM4s·qòN+¶œšÆSÔÂ:ñ]pgÏb bÜ/Zêƒ<,L iW×LYáÕ™FEëZ¦pT‰IÅjŽ ˆ®kCšHÁ ‚œ©hz˜·1ðk6Žºr9»¸óšÊHô)Hæ®âàÖ2G£JG#^+ #Ö¡3ŠÔ Èn+žhöhLàµ;l‡®Y£ÝÃTØò}vДb¸*Äú¬ [4~àÁ>µ­#Rý˜<#¤é—^m惩ØjùnŸgîåºTË÷7P6W#çÆr’ÇÅÆ¼¯ÔþˆáJñ¯•RåzÆéúݿɣíjã>Œ( € ( € ( € ( € ( € þmou={RÔ5íoRºÔu½FâK»ÍBúfž{¹äbòK,ŒK;³ÌÄ’I$ó_=‹›¹ûá£&EÒ­‡ËÅxÕn~“€Q[ð¤7ï^ãšàϬÃJ-h}yà±yc84 •ËÄÊIYÆ…¶¾?ð¬¾#Ñíæ_è6r=œvÊ?ÓÐ2»Báci$m«'”ŠGÏ'<1¯¨È³)`jªmû’jþ^{Ùt¿’? ñ_‚©qNXÊQoF/–ßm]7h¹IÙK٤׽'ÝŸ;|5ñ#\C"_›õúÖµÕóψòïg'+ý¬üL‡áïƒuïß“,e¹•`ÜËçÊHXãܶw`…Ý“À5éWÇ,uå´WÞú.»½‹ÊøZ|O›aòšJ¬¬ÞžìV²•›ùbœ­tݬµhüzñOŠ5¯ø·^ñˆg3júµËÜÌw;,y?,i½™„h¡Q“µUGjü«‹©Š«:õ_½'ø‹eÙß|1Ãø\‡/ÃåxÚ•¨­nÛÉÙ$å'yI¤¯&ßR[h6€1^EIÜý C•$mAJåœ{HÖ‰0sÉžÍvEÄZɳ¶.Ä•›ge8£Jͳ¶œ ѧN*:cJXqRÙ¼QÐÙÆ­Œ­C6Š:»;PvàrjM¢ŽëJÓ •ÊÔš¤z~‘¢ýÏ–‘¢G¦éz!ÂåhJá)(#Ñô IR@­áÊÅb¬z~“¢F6åk²Ï›Åb›¹èVz,eS ]q¦x5qnû›Ðhè¸Ìu¢¦pÏßSb-*"1²´P9'Š—s2ÿKŒU*% 41NOVy¶¯gÙ\~ÇR'Ñá+W­Ú€²WEcé°µ9• ñ-¿úÎ+z´Ïœ|MÛ‡’5™åªŸ‘VŽZ›Ö0¶‰æÖhÜøkðóRø»ñ7À_ 4†¹ŽóÄúµ¾œ×V–mxöP»5É…H,ÅæLÿ2€‘±, Ž“«QEĘøà0U+¾‰õµßEógö1¥ézf‡¦iÚ.‹§Zéú6Ÿv¶–P¬0ÚÃ…Hã@TEP(ö)$¬æÙJS“”Û/S$( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( €<ÛãÄ3à÷¿ˆ?5eµ’×Ã:MΠ–·w‹f—³"&ØLÀ…y¥òâO•‰yb@19¨EÉô7ÂЖ*´(Çí4»üþ[ŸÆ=Ö¡©ëz•þµ­ê7Z†³¨O%ÕåýôÍ4×SHÅžI$bYݘ–,I$’M|ÕY]¶ÏÜ048F1VH¹ô®I3ߥB5¬[=*q.Ƶ›gu8—¢N‚³g\"hÃN+6uEöñr8©lèŠ:›\㊃¢(ït›.T‘RÙ´QëZ€,™.£«=ÓÃÖ`%Ta©ÏV¼ylhÐì‡Éò×m8Ÿ7­¹ëº=¢œWu8Ÿ'Œ«¹êL.vÓGÌb¦v¶Ñ\ž+¦(ñªNì–]¡ ¦É…Û9N^¹æÏ[ Í5y¾÷"¸ê3èð<ƒÄãÌ® ¬úì6> «¨Ý¿ºÉü›_™öìqðþ[öˆð€u<ßXnÖüIóíΙnɾ.%ŽOßHðÛ§Ú<ÀCF 4•öæ>“åz½¯ü ÏëÖ½³ó Äÿø)׆u+/‹Ÿ üi,ÖÇHÕ¼>úT+7œ³Z\¼²—Ú­ô;HbIWȽœ®~ì£çùÿÚqåªR­ÑÆßs¿þÜ|cáÃû´Å}%-Å3«=»Ãíò¨ô¯J‘ñXõ©ë:Qo5ÝLùlR;ûÂ×TO¹×ÚEo˪n'ATs¢uëI›À¹e#¶‘«nzW<Ï_m[b¹f{Øg±ÒZ•ÅPú|Øé-Hâ¸jQ„gGjzWD}F ›0ž•Í#Ü¢ÍHMsÈõ¨²Û+4vIèU~kDrL®Ý Rg4Ö†UÀë]0g‰FÂõ®¨3ÀÄÄÁº^µÙMŸ;‹‰Ï\'Zìƒ>sáz×Tàâ`c̽k¦,ðëÀÏu­¢Ï6¤J Ú,óê"³ ´rÉ0ª0’!uUX“æ>¼Vmäs·qõ¬¤ŽúR9˘³šÊHô)Èåo¡á« #Ô¡3Œ¾ˆ|ÜW<‘ìP™Áêq}î+šh÷pÒ<·Z·Ï˜1Ö¸j#éðsØý ÿ‚dxãÉÔ>,ü.½Õ¸qmâ 7Kû?¦mï&óBÿØ=v3{¢ÿ¬5ó­;J3^Ÿ×â~éáþ3ž\3{ZI~ ßÿý:Ÿ­Õ䢅P@P@P@P@P@Ã/‡Û ¯šÆ-Yûg»B(õ(}ÚñªHý3A;³áërï#½qÉÜú*0åV>¡ðS¼k? t5)Øèœ9ãcê1>UvR•ÏšÌi(&|-ñwáö¯ð‹â§®ZhSÚ|;Õo÷i—«åË$cÀ‰UÚUT”ŒãpVjýC!ÌãZ”c){ékù_]üüÏá8&®[¯Z°Õ$ù–»JN)GáI¶¢š^êÒöløcâ—Åmk⎣ºù¶ž³rlôâßy¹t¸àÈA ˆ 9fn,×6ž:VÚ eú¿?ËïoéøÃì7 Qsvž&kߟ–üꢞýfÕÞÑŒx;+@˜â¾z­KŸ±àpjìQãÇ)CF•HcéXIž½ fš'JÁ³Õ§Ò-fÙ×c^õ›gd"hD•›g\"hÃ"¥³¢(ß´‹8⥳h£¤´µ¤Ú1;.Ĺ5 Ö(õ-O'ËÍ©­¢iÅŠü¼T¥v9IE\ôý7Oû£mtB—ˆÄ•¤iŠvüµÙNÎbñ-\õ 'HL)Û]”éŸ1ŠÅ³¹±°PUvñ]1âÖ®÷:HôÁÇË[(t±#§µKt< ÔÜl… ®£9ÛçSXËcРš™äÚüè»ë†«>«ìxwˆ/°²óÜ×›VGÚ`©isç¯_‘æa¹¬=hÆÇÎ>"¼-q&MSg•ê·‹kH£’¤´8«§ë[ÁN"VGé§üám¿‹>7ø¿â†¡ ´Ö¾Ò–+@óÊ“CæD’¢/Èè-¢¾Fp ÈB’7'Ðäô¯7>Ëó?ñɆ§†[ÎWò´z}í[Ñüÿ¡Šúò € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € (óCþ ÁâýOò“hvZÉiâïéÚ=ë\+3Å ¯ƒDCͱ…I`Ãc8ÆHeãÇK–©ô|-AVÌe7ù/ÔþjàN•ó³gì˜xÑ/Jç“=ŠQ/F½+&ÏBœKÑ­dÙÛ—â^• PF¬ Ò¡1Fíœy`qPΈ£¶Ó ÉQŠ–ozF“j2œT›$zîƒeó!Ç-ÅQ{§·øzÈü•Ó O¦Ç³hÐ( ]”Ñ󨹳Õ4xWåâ»i£åñsÜô­25P¤×dóx™6nÔpN+Kœ\Œ†k”ò›&“z o˜áµ[´†êæ©#ÛÂÒló-Zñ>oš¸êHú\%x÷ˆoSçæ¼ú²>»/¢ôü0r‰_QDü2ѳÜ4…Zô©ŽÕž§¥œ…®Ø/Š=âã­u@ð+}©8<×DO.¦æÄLãUÙS?&\K‘œb²‘×Mšv¬&zøvm[žErÌ÷pÌè­[¥qTGÓa%±ÑÛ0⸪#é°“GGhÝ9⸪#ê0r6á5Ë${Ô« é\ò=z,´NqY£²Z¢&ª“±Œ‘  ªFZw Öº Ï'uë]Pg‡ˆ‰v¼šë¦ÏÆGStë]pgÎâ aܧZëƒ< T YW­uEž h™²­my•bgÈ+dÏ6ª*°­É$@GZ³ ž•HÉ™÷Ô³H3ž»^ e#º“9Ë•ëYHï¦Î^õ>õa$z”YÆßG÷«žHõèÈáµ(¾õsMÞG™ë0}þ+Ž¢>—=mý…üC¨øoö¦ð®›c ³Ûx—OÔt›ÆX´p¬ x2þm”C$0ÚÎ1’ð3X^•û3õÎÅJ‚¦¾ÜZ%Ðýó¯œ?h ( € ( € ( € ( € ( €?† $&¥|æ3Cö~¼’=wL Jýá^ U©úÖÚ ™áýlÛȉ(Q\ÒG±JgÐþñþï ö¨hë„î{Ç…¼ýÆBŠ­˜\:2ˆÉFó6îåõfê§MÙ­n~QÅÙ~8”ñ±æ„ýÛ5tÛÕvµ­{Ý5k§{„6Qí b½²¹ñ¸\§KaEpÍê}V’4¢OjÂLôéS4áJÂLõ¨À¼‹Y6z‰i¥fÙÕ—¢^• P‰¥ t¨lëŠ5¡¥A´QÐÙE’£,Ú(ì,`É,Õ…£Úd¡Å#Tzöa»gTî[vW=kF±` ZÂ' zº3Ó´» •ùk®>_sÓ´}?îüµÛNÍc1ž¡¥Øü£Ší„O™ÅWÔëí¬p·Q<Š•ÍƒAÓšÒÖ99¹Œ=Hü¤Ös;pëSÏõK.'×$Þ‡½…§Í$ÏñïúÎkέ#ìòú; â;ï–^}kΜ®Ï³ÃRå‰ó߉¯3æsRt=žµë¬Ï/5Hæ¨Ï=½“9­bqUg+tüšè‚<|LÏècþ Yð›Rð'ÀïøçÄ~¹ÒußêÉskuvì­¨iÀŸdD[†Y¯YXª³««|Èb5õ™]'N4•›üº~§óÿæÆf*9óFš³·I7ïkè•û5mî~ŸW¤|@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@ø‰ÿ™Ôõ8ìg]-Fé4k©õË«‹™„3ÍؤRÕhå›2å9ÍhŽJŒÏ”Ö¨áªÊ÷­¢yÕLÙMmˬÌÉMoʬ̹Ž®ˆžMwcå° tÁ&&Z3ôwöýµÚ7⇤ñ†‰zÿ|(¡üGxÒ½ÚîYtÓ¡` 4…¥‡ÎØT¤9;â‘áÝéV ÜáN[F*ý,ÝÝ¿sâòÌÒ4ð¸¬U(¥*õ%ÊÓRæ„i©]t¼dâŸVíu«þ§ëcÌ (óƒþ cà×þø_ÇÖšGÚ5?k(³_}£gØôûµò¥ýÙ`}ÊØœc# ¼×~]>Z¼½Ï‘ã<3­—ª±ZÁýÉéùÛú¹ù%ái²¨>•õ”Yüû™ÃVÏrÐ_•¯N‘ñ8äzÎ’s¶»iŸ+‹G¡iíÀ®¸Ÿ?ˆG]hßv·‰åÕGC6ƒÞ´èrõ,޵,Ö%¨ÏJÍtÙ©c„ÑëaäkÂÝ+šhö°ò7­[¥rTGÑa$t6ÍÓšâš>“ #£µp+Š¢>Ÿ S¡· Ž+–H÷¨TF´2t®yDöhT.ù¼V\§wµÐŒÉO”ÉÕ"i85IJ®†tïÖ·Š<ÌD̉߭tÅ."fÓrkªš>+³ sÖºà|þ!˜w$œŠëàbÌIxÍuDð+ngKÞ¶‰æV3¤­¢yµJÞ´GˆzÑò#¦Œ™JeÈjL¨³ éx5›;)³¹N dÎúlæo­c$zTdr±çua$zôdq:”_{Šæš=œ46Ö"7ÇQG„‘¹û9øŸþ¿Ú[àÞ¶4ï¶yúÔzW•æù[~ÜeægkggÚwíÇͳnW;‡‹™CžŒ—ÏîÔý;‚±?W̨J×»·þîþ¹ýWÊÐ@P@P@P@P@Pñmñgá÷ü)ß¿~¥®©Ÿá­~÷O°þÛM—SÙ,­öY¤ù7›ŠPê¡]d £k ð1ôìÝ×8OϹi’¨Û†¯i¾‡ëxYÆ6jGc ŠE NÔW4“G·N¤f@ðÅìñ²I\ðk6uÓg§êºýŽ¡j!Ô¥)ce M&C6»ˆ˜áTdd;ÕR¥*ÓTã»#Ž£–ájbë»B ·¶½’»Jíè•õm#ó÷Ç?â÷w‡4¿ JÒÓËAå\Ý^\G;ïqÜ–VÃ<¼€ 1>6g'Íù¤ð=(ªj¥«•¾I+~lü¥€t¯G锩é\ò=jH»dÎè"üB¡pF„ Ȩ:boÛ/@jˆ5„cx¨7‰èZ\|%K6G§èñ’‘¢=Dp1DEWá=cGŸ„É®¸3ÁÅ+žŸ¤ÎÒMvSgÎb¡s¿²¿šº£#Á­CSzC§ÍZ)œ3 Lú˜Aך|ö!a®b_ê¹²Õœ¦vÐÂêy¶¯©gv¸êLú,&ó]RüäµrNGÑá¨Xò_}þkîz4àâx¦µzK8 Y‹cËõk½Í4D™ç÷Ód±ÍR0“9{‡É>•hç“1æ<š´sM™Ò·ZÑuŸ!ëZÄáªÊž kΫ#2SÖ·Š<ªÒ3&=k¢(òkHÊ™«¢(ò+ÈÓð~‚ž%ñ-†›:HÖ º{¢¨ÌH7Ä´17d`¸ï^®[†úÍxÁí»ô_ç·Ìüÿs§’eUqÚU£ R÷¤ìšºwqW­ª‹¾—kúÛýƒ¬u?öOøM©asgs*j+Ü-42êRÅ (ñº:·FWVô±oš´š>+‡éºYmÉ[Gø¶Ï®ëœöB€ ñßÚ À'âÁ/‰þ‡IþÓÔõ-àéÖ?hû?›¨D¾u§ï7(¹Žó0CŒ6T‘ZÑŸ³©9žë˜:´-vÓ²óÝ~6òî8ž“r@Aê+ìè;ŸÌÙ´lÙïZÁŒæ½JGÂã•Ó=cK“kº ùLTnzœä…õ®¸3ÀÄDìlÛ[Äò*£¡†UÆ+Kœ®÷/)4ÔU”ŽºFŒG¥c#Ò¤Í8[¥a$zÔ$oZ¶1\•ôXI›öòt®9£è°Õ ëi9×%HŸC„«ª7!–¹%ߣTÓŠ^•„¢zÔk¼u¬ùNÅ[A¦J9IunFÒpj”H] 3IZÆ'^¡•+u®ˆ£È­#å¹<×Lá⥩‰9ë]pGƒˆ‘q]0ô}êç‘ëÑ8­Is¸ ç™ìá™çºpÕÇPú,#<Ýç!ÄË ‰§Zŧ¯“¹ýDWÅŸÓa@P@P@P@P@PóAÿjøWsàÚcIø›o ÑÑ~"é0Î÷7Âéý¡b‰k4QF¸tE·{’àîyŸkO;NúŸgÂØÎGìû?ëõ?<´ûÜæ¼ Ò±úæ~§{¥n ³pž•ÁZÑ>¯.r¬Ó{Ïàø£ž"ǬgŸ¥q3é)«œoÇÏO¦ çS¹Ž'‰ÏÎbCæQžÎ‘‚pGÍêEzyE>jüÿÊ¿¿Ìø1¾Ã*Xhµz²I§¿,}æÖ½ŠoU¯v’­PW¹QŸ—a)¤Øq\“g¿‡¦™­ãÎÙìÓv5¬›;éÄ¿¬dz‘mEfÎÈ"ÚÕ,èz!’*ÕlÀ8›:"kÛ¯J–l޳NQ…¤k¼Ó¸ÅI¢=J€Ph[ÑŸ+(‰¶=oH™cUÉæº ìxXˆ¹­•æ^>{Öñ‘äÖ££=M¾û¼×\$xšao«¤I€Ã5ЪXò*a˜èµüJÇ*º„°7ŽÆ}ÿ‰TnùÅD«ÑË™çúωÁRŸ­a:§¯‡ÀYìyGˆüY±Y|΃ָjÕ±ôø ¿gcÂ5ï4…É“­q¶äîÏ¥„#J6G‰øÄ9óБ2‘â:ƨÓ%¸«Jç4çdpWWEƒsÞµHá©RÇ5w>‰=x®šq»dV„[²ß o©ËpÞÊŸ´{¿Èüs—ŽÅ}N›÷)ïç.ºù^Ý5½ú«µéŸP@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@üëÁ_4½N/Ú#áî³.tš5߃ µ‚ýáa óE}zÒÆ’ck:,ð3(9Q*Ã>.fŸ:~Géœ 8¼=H_^kýé“ûËXx²?M 8ûV=JEØúŠÍÔËñô5›:ài@9¨gLMÛn©fñ:{ ëPmд£•&Èô½.`¡ Ñ§£JÏZ"M]QêZLª¡ICÖ­se k‚«3å5´QæÖft§­o̬̹ZèŠ<Šò2'lfº +G|øu¨ø’ëB´Ó涃Ä>7Ôíü?¤Ëy#,1 nò2n! ÅAù  Ø?Y•PX|4±2Þ[z-þ÷ùyŸÏ¼š<ç9£‘Ð~í&¥?ñÉ{«kû±wºm>{5xŸØ?†ü;£øCú„ü=iöME²ƒN±µ2<¾E¼1¬q¦÷%›ª2Ä“Œ’O5ÂÛ“»>ª8Ò‚„’V^ˆÚ¤XP@-Ñè7ÞñOˆü«Ïo6­áÝNëHº–Ñ™¢y­åh£,”,‡¨8Æ@é_g„¨§%Ôþhâ,$°ØŠ”e¼[Zy3ØôIrR½zlüçÏXÒœ|µÝ|¶*'¢é­÷Nk® ùìJ;;F è‰ãÕFô(p­,s9šQ)éØžk—c5FôähDÊÆHô©Hщ¹¬$NŒˆ%Æ+šq=¼=k6óŠæœOs ]›öÓc¸çè°Õ¬lCsÒ¹¥Û£Š4â¸VêÑÄq޵›ÝBH_=ir1ýa ii¨‘:êÅ)e­c†­c>I:ó[F'›V©‘pà“ÍtÁ.&wfDÄWDO³2.s]0CÖ¶‰æÔeF­Ç"»u«G<ˆÏSTŒY½ 6%¹‡sÞ³‘ÕLçî{ÖR;©œÝàá«“½z°‘ëQ8½A~õsÌö0ìóÍ]>õrT>ƒÏñdy‚qŽ«^}}°Ê¥i#ú›¯†?ªB€ ( € ( € ( € ( € ( ŽÿmoÙ?Lý¬¾Eá›}B×Hø Ü6¥áÝjætIö{YÜ+H¶Ó »ü¾CÅ …dò„mZj¤lv`q’ÁVU«©ü­i¾ñ†£¥\éRÛëZdòZßi·ˆð\ÙO’)a`X*à ‚"¾{VÓÐý‡(¯íã”ýäÏC°ÒüMéOjò+A>§èyv*¤R\§I¦jš…¡žÕÇ27ιäâ”l}5®KCž-ëwZ¦·¥é÷Dëe ”å‘ä#!¹þê!ç=Å{ùM>J2Ÿwø/øv~Kâ1â38TÓTã}7NOTõí´­}o³G lœ é›*ûß½ýk7T쥗ù«â‘µ‰“§½c*§£Gn‡ë¾%iÉ“L×;nNìö!ÒVG‘k^"yó?Z,)Hò=[WyÙ‰c¶­#šS8‹Û̆­"ŽJµjâ`:šÞ1¹æWª¢Ð/ø'ÿìqûAxºŠ~/{døEá V5šÊUŠáõûø„s}¡pÊ-¼FfuùÖAYÞ/o-Á{Wí%ð¯Äü·8¡``ðt?‹5¾«•;«ß¾ö¶ÏWÑ?é:¾üT( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( ßø,ÉÄ¿³Xõ!ÿÜeyY¦Ñùþ‡ßð#µJÿöïþÜ~)@Ex?YóN.Õ„V‘z>µ›;à_޳gT (:Ô3¦&ÜT³xƒ| Ú'}¦Ê/<Ô³dwzuÇÝ ´z~v!&š3›¾ˆô?PGÍO˜ÏØÝ=®£Èù«HÌ嫇:‹m\"€Xf¶S±åÔÂ]’ɬŸïSu Ž ¤úËz§Ú,0ïõ C|üÖr™×G “<÷TÖyož²æ;• ?Õu¢Q”?&¥êtS\‘±æz– X±-@6yî«{Ø4Ò3lánæ,XÕ#3ž¸~µhÂLÆ•¹5hæ›3ånµhå›)HkDŽ:Œ£!­bpUf|§­mάÌÙš·Š<ªò2¦nµÑyä.…£ÏâoèÞ·iïîR–(Œ¦'ç #!sžG ykÑÁaž&´).®ÝíÝü–§ÅqFs “-Äcçgìâä“|¼Í/v7ÖÎNÑZ=Z²oC÷ƒþ ëð‚O|c—âu¼W6ž øsfÚv›´¸K›Ù ku„;£ +W‘œ Eim‰Ê±Ï×f•!ªöZ|–Çó×౪Õ3\[¼äÜ›µ¹§;¹=º¶Òµ®º·µáŸ©P@†¿·çƒ?áý¢‡‰­áÔM§‹´{[é.®SýÝ@ «Å…å† We%˜²H }QSš›f~5âÙc#]'iÅkÒëK/’_yàþ˜²DIçô´™øŽa 6`ÒdP×}6|Ž*:³Ñ4é³¶ºàÏŸÄ@í¬Ÿ;k¦,ñ«-NªÑÆ5²<ê‰ÜÓSM™2†o^«&ŽúR/Äý+#Ñ¥3RéXIµ šðH+šq=¬=Tx'äW< {X|A¯£Šæ”Ojkš1ÍŽõƒ‰éS¯bÚOÇZÍÀ질çÿµK”ÓÛŒyøëM@‰â Ï6{ÖŠ',ëÜ¥,Ýy­cÏ«XÊš^µÑžEzÚ™²ÉÖ¶ŒO2µS&wÎk¦(ñ±¹™#u­â*¬Œù[5´QæÕ‘FCZ£‚£+9«G$ˆSZ#žDg©¦Œ™^j#硨‘ÓLÀ¸k&wS9˿⬤zŽRðš°‘êQ8ÍH›Ï#ÙÞyª½\• xÿ‰—tRý+Ï­±õÙc´‘ýü ¿Ôu_‚õM^þæûV¼ð¦“qu{y+K5ÌÏg<’;ÌìÄ’Ä’I$×ÄÖJ5$—vP峕\ÉݸEßÕ#Õk3´( € ( € ( € ( € ( € ü‹ÿ‚‹þž-ø‡¨'í%ð2ŸâNbkž±·E›_µ‡q[ˆ (io#BÆåŒ±GG‡‰#›†Uãæ}ç•2šÉ7î6~[x+âî‘â/êyilž"µ‹p™]ëМzôýkäëaçò³ú.ͰõðÊ­.¨ðÝWÌ—·²7Í#çÞ¹êSÖǯ‚ÆZìðÏÇxŸW1î+,Þq.yË€çðË{WÐá¤å‡ƒ}­÷h~;Ñ…,磪ræ×¼’“ù]»y[(À¬¦ÏG cR%èkžLõ©DÒµa#Ô¦´.¥fÎêe¸ë&vÓܶ:ІvD´†¡›À»æ¥5 aPÍâÍ8¤Á©hÕ3zÒ\cš“DλOTÆ“5Lì¬ïÂmÃb‘iÆ›©—æ lï4ý]T)-ÅQÏ#«ƒÄAõW1q»4¢ñ ·W¥ÌËTÓ-ÂAŽd¥ÎÑk ¤dj)TR´FÍ#†„NRñ`ù‡™úÒ»4PŒvGâBêäÉÇÖ‹•1Ö¼E÷ÿyúÓHÉÌó-CWy˜åø«HÂuVò÷9«Q9gVÈçn.z’khÄó«×I]žÓû8þÎ??j/ˆø7Á±ýD³Ù6¹âk˜‹Ûh¶ÌH ÀæLûXE ¹Rrˆ’Hžž*ò²Û©ðÜIÄtrš.sw“øWVÿEÝôõi?êóÁðŸÃo è^ð6…m£xOF€[ÙiÖ€í‰rI$’Yݘ³3±,ìÌÌK1'êáÓŠŒU’?Äb*âêʽysNZ¶ÿ¯¹l–ˆêªŒB€ ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € üÅÿ‚°|=ÿ„§ögµñµµ®˜/¼®Ú_MytŸé+eq›9!·p¤üóÏfî…•X@ %‘áÌ)óÑ¿cêxGõ|ÅA·i¦¼®µ»ù'÷ŸÎ¹Í|ÜÑû^F¬g¥sÈõé2ôg‘Y3¾ ¿¨g\¡ r*˜³jàTÄÞµ›k)&©}…Î6óÅ&S;K ¼m5&‰Þ©à. +¾Ÿ«0ÛóT´Z:Ë]Ppw`úSR±2¦¦k.¯Û}>r>¯Q«ä}ê9Åõx•fÕƒ‡£˜~Á®¡­›G0½’8CWß»-Airœ>£©ç?5làõK;€jiÙÆ^]o$LÊLç®eëVŒdÌ)åäÕ$a)’5ZG4¤Q‘«DŽZ’);u­8jH£#u­R8*HΕ«h£Ì­#2fë[ÅUi€MuA.&¥®}Eû.ü*×¼oâ=7ûÀMâ_^.‰¢,ÑHÉcûû§Û2Åçt©¨—†}nKAa¨ÏQyGõ¢i÷Gólj¹Lë1ÃðÎ]TêÙÿàv{%yÊ2üû’gõ•ðËáφ¾xÿü!Êè4MMy1ši]Ý¥’Iày$w!B¨,Bª¨ 9*T•Y¹Ëv} KBj+ÝŠ²þ¼Þ§yPuP@œ?ðQ߇º¦»àO|I°—u—ƒ¯f·¿¶Â °^˜#Y·åš#تÄùû¾P‡>®SUB«ƒëúâxœq0ÿ—mÝyJÚïѤ­®þGæ?†îTÆ A¯¯¢ô?3~õÏcѥܪ3^…6|†2g¢éÏ÷k®ÏbÜØIÀ®˜³Ä¯¥‚FâµLàœQµ ¹´sJ6ؾ§¥&Te³hë„‹±·JÎHí§3J)1ŠÂHõhÔ±¥½9¬%Ô£TÔ†^•„¢zÔ+±O€9®y@ö)b,‹ÉqÇZÉÀï† ²“ûÖn]ÕÞ®J‡½…<“Ä‹˜§놶ÇÖeÏTB_³ˆ´oþϵ-óí60x~ÏMy<·mŤbÖá0à²h%LãnT• ŸŠÄ¦«M>ìþžÉg™nQb+îI?Ä÷zÀô€ ( € ( € ( € ( € ( €?&ÿl¿ø'§Å-cÅ>^[èo-f¸Ôü*Ѭv~'»%I•%,«ks"ù›˜ƒ²ùlþSf~,V W÷£¹õÔÊß±«­7øšþµØüÕ¼3ã‡úŒ:įk¾Ö¥ˆ]C§köYM4™VeIQX¡d‘AÆ2Œ:ƒŸÄáeMéùXýw%Ï)ci¾k+;{²ROmn­oG©å>"žŸjÛ°h‰@9ä"‚?0k»xIøsðçIû‡g™&¸˜‡¹Ô®X%ÍÌ€2gÚ¹8TETDEúšT£F*Zƒãñõó*òÄb%y?¹.˲_ð^·gªV‡P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@rž<ð~™ñÀÞ3ðµ=Ô7‰´›½îk&Tš8n!x]£fVPá\J°Î2J™EN./©­ ÒÃÕXïšù;ŸÆ6»áýoÁ¾$×ü!âk/±ø“B¾ŸLÔ,üÄ—ì÷0HÑJ›Ð•m®Œ2¤ƒŒ‚G5ò• á'Ðþ€ËqQ¯J`_1±7Jä’>†”‹ñž+6]Fèk6uÁ—¢njYÓkC&;Ô3¢,Õ‚lÍKF‰-Æ1“Rj™ÔZßcsÏII˜óÏÔf­# HË‘ó“T‘„äQ‘ªÒ9§"“µh‘ÉRE9 h‘ÅREZµŠ<ú²3enµ¼QåÖ‘•<˜º #RÆÇ‚<)?Ž [ÜÍ«ümÔt£‹¥Ä|;á(ncf¨¡nn£2FI„¶I£”ŸøüÅ}g^>îž‘é²?à|ªªö¹¶3ZÕ[w²Wrw”¬’Jíô²ÝXým¯$ý ( € (Íþ0øþW¿ˆ^Ž×Nž÷[Ò.­lƬ»­â»1“o+ü¬W˘G uRÊP2ŒZRŸ³œgÙœ˜ü7×0µpú{Ñi_kµ£ù=OçÂ7æHáfnHÁ¯¹¡3ù[6¡Ë&‘ïZ ùÛÏéÒgÂã z†Ÿ(q]±gÌâ"v–ýÞk¢,ñ«Äìmµ¼O*ª±¹­Vî]SÚE–Ô4tA–‘±Y´uÂEØÛžµœ‘ÝJF„OïXɚˌsXÊ'£Jµ‹ÑÌ}k'Ч]—c˜Žõ“‰ÝN»îYYóÞ³p:£ˆó$ûÒä4X çÖŽ@x‚&›Þ©DÊUîWy½êÔNj•ÊO.kU‚¥k•$“­h¢qTªP’Nµ´QçU©r‹·ZÕ#†¤ÊŽÕ¢G äTsZ$rND {Õ£žLˆôª1laªFl¥1ëI•äõ¬äuÓFËpk)´‘ÎÝž e#Фr×§ïV=Z'|~õa#Ö p:ŸñW,Ï{ y7ˆFå“ß5Á[Sê²ý?C?à–ÿ Gø¹ðrî[d¸[”ñFŸÃ/:ºÇmvÏ'1„B–!Wåbesóv|¶eNÓS?{àœbžXgºÕ~OôûÏךó¸ ( € ( € ( € ( € ( € (Äþð¿´;ß xÏÃz^½á»ÍŸiÒu«8¯-®6:È›â‘Yk¢0Èá”ÈšOFTg(>h»3ñ+öÕÿ‚ZxoNðœe ÝÛjz$ uoÇws~ú´–7M;É!¹PHh7*å*쟚­ ÇÜ=¼¿6p«lCÑõÿ?ó? ­Ø8VVW•5múJiJ,Ù‰¸Ë${”dhÄÕ„‘éÑ™} dÑèÂE¤jÍ£®-£Vm‘a[Jƒ¢,²Œb“FÑ‘r9*6Œ‹‰.1ÍKFÊEØçéÍMT‹ñ\ŽiX´Í¯ ò•‹R/Å©?=sSU~>sH®rs¬J 2‹9kRu2~´X\åWÖ¦?uéØN¡‘qªHÙÌŸ­;êjNrU(™J©•5ã¿Þj¥ U2å¹<óV¢rÔ¬eOv~jÞ4Û<Úøµ§Ü_²Gì%ñö›þÏñ¾³wÿßÁx+ZL‹Í^4ßæ®B­µÐDÓIˆÑ¶‰š)"¶/•ozZGúØüï‰8Æ–]z½ê¶Û¢íÍùÙjü®™ý)xÀþømá= À¾Э´o èÐ {-:б&I$’K;³fv%™™‰f$ý!qQвGã8ŒE\]YV¯.iKVßõ÷-’ÑUQˆP@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@Póÿÿ@ý‘σ5íCöœð8φ¼C >$Ñ­ì¶®™zéµoU¢M¢Ý•¥!¾Ó2ÒöÇäfoù{™ú'g—¶¶ëáwÝvתén‹¥µü·2ƒ^ Õ™úƧ4M(ßšÆHôéL½v¬š; Ë‘¾*:a#B)zT‘£¼ŒÔ&kÃuŒ M)6÷¤cš“DΆ×QØÍCE¦mC«µSb¹XµnÏúÐW1gûd€ô0ßí¦þñ 9Šw¹#—ýh‘‰>¨NpÔìKf<ú‡\µ;ÙÏÝ^ïÏO<Î0™>¦;QB•5vßõvÛÑ%vÛI&ÚGèŸìµû6\øïǺ_Â]ÿθ¼òõ?ê°Ý®› ˆ’ý˜2¶Xyþ\#’PÎòþÚa“áܼå»é~‰y/½ýÉ/âs9øç÷únŸc¥j·“ëš$YQÓn'—ÉTEËòö´E ŒÎܦÖo­Ëkª´—u£õ?žx×*©€ÇTN)FM¸ÛnVÝ´émU¼´Ò̃B¼ÊÆÀ×½JGäøê6lõ.ãr¯<×tò¸ªvgwa7Ýæº`ϼÎÊqÍtEž=XnfµNç Õ5lTd‰Ô⥣hÊÅ…j†ŽˆH·Öm”æ\I=ë'ºKi/JÍÄì…bäs{Ön'm:Å•Ÿ›×E‰–ãÞ¥ÀÚ8‚a?jy Ö ažŸ!7Ï÷£Ÿ¬¼ÙïV¢a:÷+4¾õj',ª•d–´ŒN:µJŒõ¢GæUv­9*LªÇ5¢9%"5Hç› '5hÁ±éLɲ68[¹Ÿ;g5,Ò(Ĺnµ›;)£äŽy¬™ÛMíÛu¬¤z‘Ë^· XHôè£ÔïV=ŠàõC÷ë–g¹†<»\Ôæ¸ªO‚v1þüHo‚_|ñQ¬~×g¢_wn±ùŽö’Æð\yK½”C,¦=Ìx]ÙÇÅÑöq?HáìÅ`qê½RßÑèûkg¡ýL×Ͷ…P@P@P@P@P@P@ŠðRØLÖtßþÓ_-mtïiöóêÞ0ððe‚ NÔÉ>¡p©rª¬ó'` ®&Ü.8ñ8u5ÍÏ¢Ésia¦¨T~ëÛËËÓòô?m®€3^=HXý ‰SF´Rt®yDöiU4#qÍc(ž•:…µzÍ£²,£ÖmP™eÖ¡£ª'WÅMÔ‰Ö_z›©–VZMÆe”Ÿêlm–VçަƊe•ºã­)L]c½+œš;ÎzÑ`ö‚ËïE…ÎSkÒOZv¨5¯p§šv3uLÙnËÍ>S9U±Mî}êÔL'X¡-×½iuq)|ãÿŠþ%¶ðwÃ_ j~"ñû[ìšdO"6‘#óf» !äŒ4²wÌ5×C *®ÑW>3Ψ`iº•¦¢¼ÿ%Ýù-OÛ¿ÙÓþ Oá_jz?Œ¾>ø’ÛźåŒës…4˜Ïö>ôi@/* .Ѓ›6B¡‘‘ÄÈÄ–Æ¥SWø‘çjE)Æ¢9 |ÿ´=è0hàu41]õsšÌS–øâ§b\ŒénËgšv!È¡,ùç4ìC‘›,ùÏ5IÊE“=øõªHÆR*I%RF™Qß5iÒ‘QÞ´Hå©2¤ïZ$qÔ¨Q‘úšÕ#Ï©3:Y1“šÚ(ó+T±s8’x®¨DðñUì›>Þý™¿gßø³]Ó´=Âç⎲ NDZŸ…qrvŸ#ïíó>#Qæ9¾ã-ÂC+¡õŒBµG·t½:7ײÓMOå®5â Oæ‹&Ê*s`©ümiÍ=ܯïSŽœº%)^K›÷mI_³÷ìûàÏÙëÁÇþ_¶ë×å'Ö¼GqKZáA‘“²$ÜÂ8A!–v’Góë×–"|Ò>·)ʨeuBŠõ}[þ¶]=nÏx¬OL( € ( €>Bý¶~YüEø!¯ë±-¼^%ðLRëö7“SäÅk¨ ìgÛ$ Ä"• ,P`»pÝ Ë³ÐùŽ.Ê¡še•/ñSNIún¶oUÓ«JúŒ¾ÔxÓkd¯·¡;£ùw5øIÜöä ¹5èSgÆã)ž‡e?ÝæºâÏŸ­®²›§5¼YåVÖZËkx³Ë«n&  YÊô-)4‘08¤Ñ¬Y:½CGL&YG¨hé…BÂÉïY´uB¡eeô5'LkoZ‡¦5‰–\w©q6k{Òä4UÃÍÍ ëÜi–Ÿ(b6—Þš‰”«´•J&ª@Ïך´ŽiÌ®ÏV‘Ï)•ÙóV‘Í)\š©#žR f«HÂLa8ª2lŽšD6A+qCêÌ©Ÿ©©fðF-Ãõ¬™×`Ü¿ZͳºœNvéºÖ2= Hå¯_­c#Ô¢ŽBýºæ°‘ëPG©ò sLö°ËSÍõdÜO+Žhú<#±åzÍžýÿ/¯Zá©ê0u­cúlýŸ||~'üøa㉵í=OQÑíÆ£}ö³ùº„KäÝþïj‹˜æ*„8ÊåH5ò•¡ìêJ=™ý–b¾¹ƒ¥^÷rŠ»óÙþ7ýb¬Žà € ( € ( € ( € ( € ( € (ù¼ý¹ÿàœÞ1ø]«|Aøçð‚ ]Wá —ªÞxvÆ 熒V‘çòíãckNÒ¥0ñFà2…ç>~'¼£±õù.r¯^»'ßþõä~TAr5åNÞáñ)­M(å÷¬OVbür‚:óYJ'¡J²e¥’³hì…BÂÉPâtÆ©adÍC‰Ó ·'PѺ™ “ +*„¢ZV4U Þô¹KUl?Ï#½.R•aÂàúÑÊ?j/ÚH£”^ÕµÏ=iò’ëµÑçš|¦nº {³ëT e,BEGºÇzµLåž-"惣x“ÆÕ—†ü! jz爯7ý›JÑí%¼¹¸Ø#ùqF ¶ÔGc€pªOA[Ó¡)»E]žN36¥†ƒ©Zj1][²?eÿgßø$Û¿ög‰ÿià~îøB¼57ýq“˼½ÿ¿ðɸþëÇs^Þ*KÞ¬þKüÿ¯SóãgRô²øÿÛÒùí¹¦ýOØO‡Ÿ <ðŸÃV¾øoá3ÃÞ‡k}“M€GçH#HüÙŸïM1Hã ,…¶‚ÌO5ëBœi®X+#óÜV.¾6£«ˆ›”ŸW÷Ùv^KDwg8P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@PÆŸ·¬¿ý›üU£xÏÃVÚÕî©4VZùˆÖš£‡òŒo byy*²*4,q):´£Z<“ØìÀcëåµÖ#í%÷5Ù÷Oþ ³IŸËF¹£j^Öïü=¬¢&¡hÁ\FÁ•ƒ(e`} ²žpyäÅ|½z¥' nÝò¬Ò–:„+Ò~ì»ïÙýÏNÝ´!Ž^œ×¢}*Åä“5“G|*\¶’T4tÆe¤—Þ¥£¢3-Ç6;ÔXÚ3-%ǽ+)–çß4¬R‘:Üã½+ÌH.Ú¢Ãæ%D+˜CuŸâ¢ÁÌD×>ôìO1]®=éØNEi''½;äTiÎ&ŒÜŠ­&j’2”Êï'©ª±”¦UwªHçœÊÎþõiÓ¨Uw­8êT)I'½kpÕ¨gÍ(ëhÄókV±sr$œ 鄉QM¶}û7þÎ^4ñ÷Œ´=/FÐV÷Ç—¿¿´²»ÊÛèP7^Þ¶Í›—©*´Ìˆ¿e—eðË ±X¥ïô]¼ßŸeÓw®ßÍ|cÆž3ÅK!È¥þ͵J‹í®±Oþ}ÿ4—ñ>ûŸÄþš>|ð‡ÀÿÂ? 3_ø‚ø¤Ú׈îc q«\pHÉòáMÌ#„1$³´’>ŒDñ3ç™êå>%ì>z¾­ÿ[.ž·gºVªP@P@üø|rø%¨þÍ¿‹>£á-R}¢j³ÂÈÒB«A+mÓÄvïÙÁWÈO3býv[ŒöðìÑüïÆÜ4òªþî´åª£éuÖÝÓÒöU4mCÌTpkß§+Ÿã(r¶OÓ.÷ó]°‘óXšVgmcp9®˜³Å¯Lë,îzsÅmyui¼ý­“8'Z97qU¹ƒ\¤á©™"œRhÒ2'V¨héŒÉ•ñSchÌ^¡£xÔ&Y*\MãPKSÊjªŽó)r”ªŽó=èå+Ú2ûÓå%Õ#2S±›ª0¹¦‘›¨BÏT‘Œ¦BÏš´Œ%2ÕV0r"fªHÊR¹Q“c ͆Æ1«!”'“®*5ŒL™Ÿ­fÙÓb\?¡³®œL+‡ëY3ºš9ë·àóYIž…(œ½ãýêÆG§I•óg5„V‚±Æê<ƒ\ó=Œ>ç¨F[?Zä’=Ì<¬pš•®íüW4ÑîaêÚÇí?ü_[ÕõOÙóTÓ5+¿:ËBñ5톟–‹ö{v†Þä¦@³5Ìï–Éùñœæ3¨ÖÓª?vàÊò­–ZOHÉ¥édÿ6ÏÐ:à>°( € ( € ( € ( € ( € ( € (á?Ú/þ çû>~Ð_ÚšòèŸð†üHºóeÿ„£Ã¤?i¸o9÷ÞZñÆé§ó$|$òlUó”V0𩺳=\qŠÁY)sG³ý;ytò? ¿hø'ÿí û;ÿjk²è'Æ? ­|Ùá)ð¼o8µ·_9÷ÞÚó-¶Ø`ó$|=¼{Õ|ö5çVÁN:­QöYwP­hÔ÷_Ÿéý_Èø¦´p °#ÔW©µ¹õ´1‘š¼]Ñ¡Àîk @ô©bWRÚÎ=k7¶Ó'Y±Ràoäë?½CÑA0˜¦¥ÄÞ5Ó%µ<¦Š·˜ï;ÞŽR½°yØhå¶Ï÷£Oa¦ãÞŸ!D×#Ö©@ÎX¤Šïv%°*Õ3–¦1-ÙôÿÙö ø±¦6µàƒZìú;Aou þ©äé0ÞÃ:–ŠKi/%¸FUݺ"àRpsÙOZ¢ºõó>sÅyv òN²¾»{Ö·{^ß3ô÷à×ü+HÓîôoãÏÄoí+2\x[‘¼ÒH³‚Š÷òbY!xT‡T† 'Ë Ø½:9Tc­G%þgÄf<{ZªpÁÓåþôµ{*Ñ4ö»kºÔýkøyðÓÀ ü5ká†þÓ<=áØ6·Ù4Ø~t‚4Í™þôÓŽ0ÒÈYÛh,Äó^œ)ƒ傲>‹¯¨êâ&å.ïï²ìµÙhŽâ¬ç ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( ÉÚ{ÆMñKâäº ‰ßáï™4ØI\o»,>Ôü¢°Ã¢E‚YOÙ÷©Ãšñß|ðÅ?Ûh^(µ ¶Ú…‹,w6ÆàŽÊà Xx8ܪÃÔ!^<³=·5ÄåU]\;ßtö~«Mº?ѳòûãÀˆ_u|Ibn|%stÖúwˆí€ò/0¡Àu´2'ä|d¤› ª¯ŸÅ`çAÝíÜýƒ!â<>g»M+¸½×ù¯5Ý^ÍØñ䛦 yî'ØB¹v9r:ÖRŽêU¹‹K&+;Q™:ËïRÑ´j¬´š5U „¾õ64S%šV-Lx˜úÑb¹…óϯéEƒœ<óëEƒœi˜úš,'2#)õ§b\ÈšSëNÆnd-'½;Êev’©#T i=êÒ0•B»?©ªHÂU ²KZ(œ•*”ä—ŠÖ18*Ö3囜ֱ‰çÖ¯ašn™¬øŠùtÝM¸¾¿l*Ý7lRÁw9èˆ (,Ä(Ï$W¡„ÁÕÅMS£ßõ¿eæÏâ%Ëò4±yhÓ‚êÞîÍÚ+yI¤í¦Ý´Lý ýd?x×U[‡šX¿×Ö ¢¾ñ†¬%‡GÒeT ðÇ2ÆÇÍa4)´”‡Ýµ#2cípøL6K9>j¶û»ò¯Âï+´1æüCžxŸRXzpö9z•ÒwNiZÞÖWi´ýåè›WçqŒ×ôðàƒÿgßxx›ízô¤Úψ®c q«\pHÉòâMÌ#ˆIgi$;ˆž"|Ò>Ó)Ê0ù>P ½_Vÿ˲éëvýÚ°=@ € ( € ( €<ö“ø.¿¾ê^ µ»·³ñ%µÄZ–}veòmï"ܘ# ”xÞh‰!ö‰K„fEÑ…Ä<5UQ|Ï?Ê#àg…–x·Ñ¯é®¶½ìì~h7767S麬öwöÒ<w‘´S[LŒUã‘X2²‘A‘_w†ª¦“OF)g8 ˜z’§R-J.Í·¦^íÛƒ^Œ$|f&ÎþÂëz©Ï5ÕzVgYg9ãšÞ,ò«S:{K 0 ­¢Ï6¥3z óŠÑ;œS…4p¯s¡08©)1á½)XÑH‘^¥£XÌ”=+ª„‚J›ªƒÄ”¬hªRåµÍ£”¯h'™G(A¾g½;ê /NÄ:„e©ØÉÌŒµ;¹–ªHÍÈeQ›c  †ÆìI^I@šަ\²džj:!&â^¢¡³¦¹‡q/Zͳ¶œL;™p5“gm8œõÔ™Íe&z¢s7Ö±“=*(æ/±‘éÑG)z ÝXHõ(;Ô9Ía$z´§c’Ôm¾Fãšçš=\=MOÔø&/‰u ü?ñ‹ÁAn4+P±Õa•U¼×šî9b1Ý´¨[v€ ‚Ï’rüÎmªF]×õùŸ¸øˆ•L%ZOdÓûÕ¿öÔ~¤×”~€P@P@P@P@P@P@P@=|Vý”?gO—3ê?¾è:¦·=ÄW3ëVѾŸ¨\¼qPKylÑÏ"ð¡Ê|‰ÇȸÎt¡SâGf0ÄàÝèM¯Å}ÏC⟉?ðH¿€&þÛ¾øuâŸø'T¹ò~Çiç&­¦ØmØ$ýÌÀ\I½UÏÍuò¼™*ˆëšx røt=Ì7ãhÙUJkîzÓðÿ3óâü7ö¼ø}ö«‹éž2Ò­lú{ïjqÍ·nòÐ¥½À†âY‚ !"‰÷oURÍ•3ÀT[+ŸM†âÌ%K)IÅÞÚ¯Õ][ÕŸøËá÷į†¿ÙƒâGÿxSûKÌûü$šEÎö¿/o™åyÈ»öù‰»nq½sÔW,ðÓŽèú 6w‡¯ðM;viœhÔaÿž‚±teØïŽgKù‰–õ•p—I­Íጶd¢óê}™ªÆ‡Û±üT{æê0ê*?ŠŸ°frÍ"ºžÃà~%Ûè7þø9ãkFÖ§ÖZÍžpl%4ÂI¼* DY+»8DÚÛŠí8Ú*“Ù3ÏÄq& uR¢Mn®¯ßmÏ­<ÿºý¯ÿ‚8ø>ÓT¸—âÇmwXÑZX­|;£A¤N“n\;M4—JÈ8(#–S¸m!ºá–SÄî|ö#Žq•©AEù»ÿ‘ú9ð¯öUýž> \C¨|6øM¡éšÌÜÁ¬Ü£êöÏ$B^\´“Ɔ<©DpŸ;ñó¶{©Ð§Kà˜Åæ¸ÜwûÅW%Úú}ËCèÔó€ ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( €<#ö“ñä^øA⛨î.aÖ5ˆ[EÓ^Êym¦K›„uG4`´obIƒeyˆÊÅM~hü<ðêÛ[DÆ>Hq@Hèz'Üù(Ðn¼  øŸH¸Ð¼K¡Xjú-Îß?OÔí’æ ¶°uÝ‚­†Ua‘Áõ¥%i+£JUgFjtäã%Õ;?¼ü‡ý§?àžž+ð w¾;ø!k©x›Â³^~óÂ6¶Ò\êDO´/’Ag»ˆHX”I”-æ$«ãb²ë{Ôõòþ·?HÈxÅTµ kQvø¯dý{?Á불üÒ‚íN0ß…xó¦ÏѰøÈËfh%À8æ±p=:x›––P{Ô8P¬™2ËŽõ<¦ê©(˜zÔØµTL=iršªƒÄÞô¬Rª;Íõ4X~ÔO8zÑ`ö‚y¾ôr‰Õ#2úS±¡—ÞˆuZ_z¥U!i}ê”LeT¥«Q9åT¬óžjÔNZ•’)I8õ­c‚¦"Æt×j¹$Öð§s̯ŒQÝž±áïƒ~ »6Ú¯·xáÁ–+£²ötÁÂA(r€fP¼8eÔ`8rµKTÅ~îô]>vÞé3ðŽ-ñ£,Â)á2&±x–´qÖŒ]“NSM)«;Ú›•Ü\%*oSõÇö>ý„ ñŽƒ¤øëÄv÷>øc{<71iLê^-¶XÎ&–}ÀÛ[»l+±s"4­„­#¤µ¹éÍkyõ)›°ÜŽkDÎ9ÂÆ‚J¦®æ6h˜àÒ°Ó4‹Lx>ôX¥!ÁªlZàçÖ•Šç¾‹Î.ÿzV8o÷¢ÁÎ&ï­; œicA<ÃKS±.CrMUˆli PKcIÍ;ÙŒÐÁ+•ZAH»æ–“eÂ&\òàͳ¦11¦—®O p‰£Dþz…|ÆqñCçú¹xpïGÿníÇëxÇéa@P@P@P@P@P@P@P@P#ã?xâ>—‡ñÁ:Š4X.î-?ÄZl„ΪÈ$XæVPádu pì;šM'¹Pœ©»ÁÛÐßÒ´­/BÒôÝDÓmtýO·ŽÒÏO±…`‚ÖÔ"Gj¢*€¡@§°›rw{—èP@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@|+ûjÞê2ÉðŸÃ©>4{Ë›ëÉíö)ß4+DÛ±¸m[‰†ïä y/…t•U…Ux@Ahbì@V€=SKÒó·å âÏFÈ%|Íñ—öýþ6Û]˯xßCñ,óËrÞ%ðšE¦ß<ÒÈ’K$¬¨c¸w(Aiã1Êíf-\õpÔªîµ=|yŽÀ5ìê7ÏU¦ÞkäÑøëûKÁ5¾/ü»“]øMi©üEð›ähì-Uµ]/3Ž)-–ºù$÷Ð'T•ž8UAo+—J:ÓÕ{“ñ*éSÅû’ïÑé½úz?-YùÓ ö©j.¯eqa¬XO%­Ý…ìM ö³#xä€du`T©‚5æÎŒ¢ìÑ÷|Æ•d¥NI¦"\ç½bàzÅp{Ô81Ä"Q0ìjyMUuÜx—Þ—)j°¾o½¥{`ó½èål'›ïG).°Ó/½>R]b#7½R‰”«4àwªQ1•uÜ®÷Ö­@æž!d¹÷«P9*b’êPšõ·á[F“g[nÏ}ðgìáãÿD5/…ð¦ƒÏïuH‰º¾>[l†d\ù†?•Ã.á_Y—pž/¹ëþê>{õÚ;îºÛGusùÿŒ~|=’Iár¯öÚý©µì×Âõ«gx·ofª{Ñq—#Ôûà·ìö|I¯Üøkà7ƒ¿¶—§ Â’ø~%w)ë%Ï)¸»¸Yh~µüýˆ|ðâãÞ8øƒ#x¯âµ‘Šð\M+;J»_0æÒ .ý»ÓN·Â’¢Âß(ñqY…\KjöGé™`r8FJ<Õ^‰ù/ó¾×V>â®ë€ ( € ( € ( € (òã÷ìS©|3HÆ‚L0jŒ\IƒÐ¡è(jH7 RŸzÌ÷ 9ƒw½`ϽÌ&G­Ì&ïJ æ&‚n&qM!60°ñLZ½ŠSÉèj[5‚(¼¸ïRÙ¬`P–p3ÍKfñ‰“4Ýy¨lé„ ™æëÍfÙÕÌy¬Û:áæ^¼ÖmÔâaÌù$Ölí„lb\œ“Y3²š2eBsïPθ³2hsš†Ž˜Lɸ‡ñY´uÓ™Èj‘aŠÂhõ°³»?@à™x‡Ç¥þ º!?ž¡_-œüPùþ‡ï>kGÿÁÿ·«•⟦…P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@ù»ûSÚyß|9.>‡þM]Є-=(è] ̘ëú=‚•RGJêÕU 0(ÔŒ¡†â€<ÛâÿøûL‡Hñ׃´OéÎ.¢²×´øo¡Ž`¬¢EIU”8Wq¸ á˜w52Š’´•Í)V©B\Ô¤âü¿#óoâ_ü?öu×4ÿ/ÁVº×‚õH!bŸNÔf¿†YYG–×]4ŒÉ.vÅ$Eƒ0-÷JòTËèÏecèð|]™a_¿%5ٯɫ~§Ä~4ÿ‚exÿG6ð†|PÐu…o3ígZ³ŸKòq·g–#7ó—ÎvmÀÆì¼sÊŸÙ—Þ}`ô¯E¯FŸçoÔù;ƲßÇß5Ãê?¯µ »kX®ôMD\cv%X¢-2ÆÁ2HÓPÁX…®J™}h}›úþ‹òìE¿{ÊûKOÇoÄñ=wK×ü+y›âPÑõ #%®©m%¬$फ ãSé\ÒÃN:I3Ú£œáë.jU#%äÓ2Eø=íQìŸc©f ê˜ï¶Z^È¿¯! àõ§ì‰xåܯÚ¦©Kæ:Ñ®u;Û=3M·–ïR»• ·´¶C,³Êä*¢"ä³@I8µ<4êÉBm½]_dpc3¼. Œñ8š±…8')JM(Æ)]¶Þ‰%«oDµg«èŸ¾9x’òk ?ágˆ ž8ŒÅµk6Ó#*Üùh[,>PÛˆÉÆ#ÙÃðÆkˆ—,pò]}åʾùY|·?3Îj2­(ÁuWm­|•Ÿuï|Ñù~qô­á,5J´rÚ5±Š÷d¢¡No–é^rU"¯îɺM«6£%kûvû|.Ðc°»ñ^¹«ø‚ö3íy‹ciqÁv™•v‚§‰¹eÏC¶¾ Áy~)W”¦ÕïÒ/äµ_øþZ‹çßIž0ÍåV–UF–œ­ÊìêU­z_»—3MkGH»/ysþ‚<-©Ùh þÁqâé­šÒÚËÃzY¹Ô/"DÞ˘զ› ö$±; 18Íz­à2µz0ŒZVºJöó{¿›Ôø5-ãʼ™–*µxÊN|²”œµÖ0¿$l›IF)E6’KC솰ïÄêÚwˆ¾>jÐè^†q+ø3Kœ\^_"´€Åqsùp#…³ JÍŒ» pùÌny:×/¼ý›†<-ÃåܵqÖm}•¯Þú|¯§T~Ÿø?Áþð†4oø;GƒKðÖ•‚ÒÆß;c\’IbK;³fv%™™‰bIðe'6å'v~·B…<58Ñ£­’:Z“P € ( € ( € ( € ( ÏÚöFºñn¥7ÄŸƒú|)âû™ƒjº–;xõ6fææ&r¨“dæ@HY_"@|ßo-Í=‡îë?w£íåéÛ·¦ß—ñ§,Õ¼n[í_Å•þÒ½’—{ÙKŠüßžKsªhšŒúˆô«Ý']¶ÛçØjVïm4[”2îÀeʲ°Èä{××PĪR‹º?sL›©*Uàã%ºi¦ºìõØëìuNWæ®ØÌùªøcµ²¿Wžk¢2ý©t›»/‹ ñ ²ÀtíOFkc |Å–Þg‘Ë `)q€A'!²@àÝŒ"ìhè¯Æ—@ǧ [u>´~€ (­âî…¨Ìõ”=y.¶«‡ ×ö ô7ÃUnüBrúý©_G+ª¿öïê~/âíENXßüýÿÜgQã|=ñߨ?á9ð?‡¼Gö3ì¿Ûºe½÷Ù·íßåùªÛwlLãÚ¹è+Ýž–"ÞÖ Vî“üÏÊp¼UŽÉù¾¡‰.k_’rí{_•«Úî×Úìó{¿‚_пü>ž°ÿãUtòlÞ„ðþG63ľ$‚÷sJëþãTÿäŽnãà¯Àß<·‡,øÝvÃ%Àψà1ÿ#åñ^'qgLÛ¿î=_þHÇ—à§Á œ|ð0ö/YñºêŽI—ÿÐ'ŒÄæU§ˆ¯79͹JRmÊRní¶õm½[z·©ÈjÚò oŸõ¨DŽœ6SM׈¯¿ÒuÐV áî•Ghcs{"7*)5òÕ±+»ÍŸ¼åÙN*¦©ái¥çÕú¿–ÛyÕXžP@P@P@P@P@óí+û7étï´É Òþ&i10Òµ‰2#r[ì·[A&bH` Dĺ†HåíÁcgƒ–šÇªþºŸ1ļ/…â:šQª—»/Ñ÷_–ë­ÿ'üwà_ˆ_5»oüEÑþÊn|Ʊ¿‚A5µühû Å ÿ€±F "«¡e]Ã?cƒÌ)âcx?óGóð†7%«É‰…¯{5ª’N×Oñ³³I«¥t&™¯$JIšõ!VçÁâp;£µ²Öó èCÆ­ƒ±ÓÛjÀÕº™æTôlÅz09­Ž9Ñ4#½éÍR‘„¨š‘^ð2jÔŽiR/%è㚥#D¶—™z«˜ÉÑ'gÖÉtÇ‹¿z9‰öc¾Õš.ÎÃMÇÒ‹‡! ¹ç­+—ìÀܵNáÈÈ^çÞ“‘J™Y®@Ï574TʯuœÔ¶h©”äºõ4›5#:[¡Ï5GDi%¹95-›Æ™™4þõ 0¦eKq× Q¦P–\÷¨lÞ1±›+dš†tÅX®¶MÞÄf,œã𛤹X9ÊòBbi4\g©Ïß(ŒVR;è;žm¯6Øå5ÇTú<¼‘û1û xN ~Î~ºþǸÓõM~æóV½BUk–iš(f ÿuZÖb»@V]®3¸±øœÆ|ø‰k¶Ÿ×Ìþ£àÜ7Õ²j7œ¯'çw£ùÅ+yj}w\'ÔP@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@ñÇí{áË»?áçmÞf¶Ñ/æ²¹†8 ªÇt¨DÏ ?"«Û¢r0Zu€<×ÁW#÷<úPÒ¾œ/&€=£K™d€y  J(  WÒ„‚zЗëSŸæ #×e~hÄüA/ßæ€9Ïj“[ø‹P¶Y1o-©v\Y]Bœõà;~uôœ3Í,Lé­œo÷5oÍŸ‰øä©Pɰ¸É/~5yS»ÑJrVÛWôº¶›»ú]Ö¦z†¯»§@þPÅæ¯tÎb÷VÆrõÑÈ¢´<•ˆy^LÁÈ À¿¥MÙ•‹àš1õ$a‚°¬ª¤pQÀÊnìòßøóNÓ"’kËÔGbܟ¸ëbcy3é2쎶&J4¡sÎ"*P’³OúߪkTõZŸ™ß?ahº†¡¯üÔ!Ô´if2'…ïæ\Ú+8n$m“(-+~õ£eDQ™Xäý;I(×Ñ÷ÿþ_øïøa9ÊU²¦¥ö³[h¤ôk‰¦’ZÉŸK©ê>ÔçмM¥_iå¶ß:ÇR·{y¡Ü¡—|n.U•†G ƒÐ×ÑÑÅB¢¼]Ñø¦câpu:°q’Ý4Ó]v~GYe¬«…).G¨5Û‡ÎVÁµ£GOk«7=m‡™W»Ðjªq–æ´S8g…hÖ‹P£VŠg$ðít4c½?Þ«R9åD¸—¤µJFN‰ao÷©óº$âôžôùˆöD‚ðúÓæ'Ù öÆõ£˜=ßµZWf1®ýZŽb•"¼Þ¥ÌZ¢W{±ØÒr.4Šov½SÌmEGºõj—#XÒ(Kv9æ¥ÈÞ4Šužõ.Fñ¤PšëÔÔ9™žó’zÔÜèP±?®R‰ÒM#KØ"ã¥;¹,;æ XÊ3Ç€sRѼ$rz« ž¦ó«Ý3S×µ=/Ú§ÚõÝZê++_1#óç•Äq¦ç!W,Àeˆ<+ÎÄÍSƒ“Ùc’ajcqèSW”šKÕ»#ú5Ð4-+Âú‹áÔÛhšE¤66væG“É‚$ îrY°ªX’qÉ&¾Rs“”·gõÝ0ÃÓjÑŠI.Éhj“@ € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( €9ïxcJñŸ†µ¯ ëQÓu;v‚BªŒñ÷dMÊÊ$F êĬª{PæÇ‡Ž­á­cR𾾞V¹¤\µÈ ê®Êx‘7…c®¹Xôô׆µA$q6êö½VU7Pw ÌS(*Ã>”b€!–xâ³ úP#ªê`† 0Õï߆ "×ïñ¼n ñ¢HKp(‡ð]ø—]ÕïÆ<˜V//{{g9öòÿ_jû¢¥^­föI[ÕßðåüOç¤vg*Y^-Œ?‰RU9¯·³-­my½­ïun]ôô+­j4SûÑù×Þ¹$%B•JS‡Õ|Oes5äh]ÌsΤVìö0¸*Ó²Œ[<›Ä|1¢Ç+IªÆî?…¸jciRÖçÔà¸_i*m#¡ðO¿Ú㦜ú¿‚¼3o x^h<ëMwÅ’Ëcð+§«Í":LeXÌ,€}ÃiùügB–¿#õîðŠJ®%rÇûÚ_Ñoóµ¼Ï´¾~Á ü>¶úÄ»»ßˆ%Žx{;š9Ô%”nC£)dIÞe/€ªÌ‡æq9¦#÷²?qÉx)Éâ­y.¯o»ó½Ïµ´Ý7NÑ´ë #H°¶±ÒlaKk[+8–m¡E ‘ÆŠª*€€^{m»³ì££d‹´†P@P@P@P@P@P@P-ãxGâ‰?‡|iáë-cG—qû=ìAü§(ÉæFßz9»"ë¸àŠÒYÑ—57frcplÆ“¡‹¦§ѯ&®»;7f¬×F|=ãOØAcuð¿Æ÷ÚEÁûDˤëh/m™Ï0Â’®Ù"NT»‰ßi’§w³‡ÏjÓÒ¤oé§õøšg`1—ž «ƒÕÚ^òòIèÒ[]ó;y­~Hñ÷Áo f˜øÁ×:މ RNÚ÷‡VKë5Ž4W‘ä`¡áU A3"±Êî Z½ì6qB¾—³ìôסù>yáÆk•7'Ož 7ÍÉY+¶ôº·÷’ÙÚé\ó+Z\1\)ö&½HÖOf| |²¥;óDêmµµãçÏã[ª‡™Sû0ëCŒ=hªsÁyë!±–«Uiàìh&ªñŠ¥3žXVY]U;·5^ÐÍáY(ÔÁþ!Oœ«þÑﺎq}Xoö˜þõáõa¨©þ*\å,9 _ú5Ū þÕO1¢ Vm@woΓ™¢ U“Q<Ô¹šGP{ìÔó …Šíyž3Í.bÕ£Üdõ©lÕSX’9æ„ÆÑd)4ÌÛ-EïT‘”¦hÇo8«Hç•BÀƒÚŒùȤ‡š.31ր6WÄ9_¿úÐ {rŸŸŸ­r†²6^€<çXÖB‡ùù  ×u±óÔà^.ñ,G*ùœ÷æ€<Óá…þ"ügø„>ÝIe ³G>¹¯H­t‹RH *‚’¾E!ƒ¢$’'^[QNŒšîº?_ëN‡Ïq eœS„–1£»54œ Ýµ‹Ýj•ÒiI+JëCìëÿØ[â ôEíˆßÞ'ôûu{2â\D—ÃøÿÀ?6¡à–QBWö·ÿ·ûcÕtoØSàu™Ôÿá%—Å>*K¿/ËMkX{qi·v|³d¶äîÜ3¼¿Ü]»~lùÕs|]]åoCìòÿò ¿á£Íþ'þVG»øKàoÁ¿\h—þø_á7XÒ!YêðéµôK嘉7l¦fvBÊÎÎY÷6ârsÁ:Õ*|Rlú¬6[ƒÁÛØQŒZê’OïÜõJÌí ( € ( € ( € ( € ( € ( € ( € ( €<Çÿ³7Á?ˆæîç\ð=¦µ?Úêú(6&y¹iÝ¢ÂÍ a¸–A»<Ì]v"‡Á-;=á¾GÎæ|)”f·uè%'z>ë»Ý»|NúûÉëêïò7‹?àŸz…·ö•×Éì@òþÇ¥øŽ×Ýy·pÿÛF]¶ÿÝSÝëÖ£ŸJ6U#÷—üà3/ èÔæ– ¿k)¯KÞKæÕ¡ÙyŸ?ø§ögý¢|ý¥<¾ mwJ³òÿÓ¼9:^}£~Ñû«~.k>÷CY¾èÝ^¥ëRÉÊÍ÷ÿ=¿à³? ³|4£Gž*ÚÁÞ÷¶ÑÒn××ÝîöÔñ]GXÕ|;©Üèž#Ò¯tjÛoa©@öÓE¹C.èÜ\«+ ŽA½ztñp¨¹¢î‡Æpö# QÒ¯-ÓM5×g®Å˜µ é§©Ëß¾Œ™éPާ™ë×!CÇUØú\ ;´~®~Äÿ ‡€þ/‹µ±â˜µ)ìùv!OÙå‘å$y·­þ‘±†cðÙ®'Û×q[GOŸ_òùÕ’ÿeeQ­Q~òµ¤ü£öVílùº?zÏcìŠó¹ ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ø3âçÀ­WÀú£x¿ávqyákɇۼ5§BÒ˦ÊÇm¬J h ?4J39QåäDç^ñõµÜQKkx’Dq‚­šõ­?ÆÑ©2΀:¼U/úßÖ€+Oâ˜ÆyúÐ-©xœ`âN>´ç:·‰×ºP©4â^)ñ¼I K»žs@<-û9|møÖm®t›ðß„îJ3x_VEhXÄKÛ[ÞNLR—CòBû ùªhõ«áGÂ|ðfŸàéí™3\]\0{Få€\ÜÈß+í\œª TEUôŠ( € ( € ( € ( € ( € ( € ( € ( € ( € ( €8McáoÃ/jw:߈>øcSÖn6ù×ú†‘mq4»T*î‘бª¨Éà;VÐÄV¦¹a6—“gˆÉòì]GW†„ä÷r„[}5m_m!_ØïösO»ðõ¿ðs©ñúêþÕÆ?à¿Èù÷À:÷Âÿäóÿä5OØá"tñŽÖöËÿ‘k§ûsÙ}ÏüÏøW’?·Sÿÿ dø‹öð}ÅŒ1øC⽦ê"`ÒO¬Á£Eµ²¢8Ä6â§qrm9i þº~üS^W_æqâ|$ÊçaëÎ2ï.Y+z%¾ÿ#‘ðOÍLù-1á6ù2µÿX%ÿ>ÿøŸÿz‡ý?üÿ·>eø“û:|KøY¨ß?ˆ'’ãÂ1ÊVßÄ–6&[y#Êi€›v&D]²`ܸ‹ÿXgÿ>ÿø~Ð{cþÿÛž{YÎc uîãïKü+¦éêì´Õ^ýÞJøƒú”( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( €<—Ç¿¼ñ gÔuM5ìV7zŸal6¨=k¶(ùšõ5gWil? ­â.­C¤¶·QŠÕ#ΩQ³Z8ÔuéZ$rÊM–0¸éLÏRÅ&ËŠ¹“sq€@5gU(\äµÀŠÃ=k Èõpô®Ï>ž=G^Õô¿èð}£XÕ.¢²´·Þ±ùÓÊá#MÌBŒ³’@äŠóñ£N.rz#ëò|¶®6½<=Þsi%æÝ–ú}çì'ìáû?iß<3×çQñ®»äË¬ßÆíäŒ?— qˆãódÃË3 ±§Ác±S›h­ë>áª|7ƒöIóT•œßK­’òWzî÷vÑ/£+ˆú€ € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( €+=•œ—j/i jE$]4`ÉnQº…cdÁ(¹è(ÍP@P@P@P@P@P@P@P@P@P@P@P@P@~WÁKþ _Ãþø÷£Â?´|8#Ñõ¿˜þóO–Söy>i*âgM©;ý³,BÅ^–]W–|©ñ|g—ûl*ÅCxhýÏäûwò?-ü=b¾£ŠúzHü'+Ù¢Dp„~•èÒGÆce¹éÖ¸]ÕÛ|Õy>‡[j#`Vñ<ª·6¡Æ+DqL¶zŠ«™45åÀëCcQ3§¸àäÔ6tB™Î^Þª‚KV2‘èÑ¢ÙÀê7ÓÜÜÛØX[Íw¨ÝJ°[Ú[FÒI<ŽB¢"(%™˜€I ã­Z0NRvHúL·.«Š©T¢å&ÒI+¶Þɦ_²¿ìåeà-/Lø—ãS?Ä]RÕf··¹…£ÿ„~ S>PG…ÉVÛ+ 䯼oi~4Ì¥Š›§~?ð;}þŸÔü Átr ûIÕ¬mït«Ø^ÞæÎî%–+ˆJ¼r#YIH ‚A¦›Nè™Â5"á5tôiõ??j§öyøŸ¶‹l"øqâ-÷2]ý¢H„b?´[I¸7‘vݺ7.î$ÇÔe¸Ïm KâGàükÃÙ˜‡:K÷SÖ:Ý­®»èÞ›èÖ­ÞÜNƒ~’*2¨ô¯ ¥+Ÿc¨8¶™év7A‚à×dd|ÝzM]¬¼^·LòêÇÈØŽà(ëZ&qÊ›cšôŒ(æE”åÔA%ª\Ía‡lç/µ„Pß?”ª #}fÉu¿ëºo…ü/¦Í©x‡R—ɵ±·Ái’I *€ 31 ª¥˜€ ®F*`ç7d¨Éò,Fe^l4§'d—õ¢[¶ôKW¡úkû2þÌÑ|1‚øòn¾']Ä|¸w,±h1¸ÁŠ6 9RD’Œ€ D;w¼¿™frÆK’Cóþº/éNðGQáÊK‰JX–½Tè¼ßÚ—Éiw/±kÉ?B ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( /ø»ð{Àß¼&|ãÛ‹69¾×k5¥ËÛËet"’$ œE™ÈW„‘¹[­hÖ sÃsƒ1Ëpù­‡Ä«Ç}ígf¯ò¿[®èü§ø¥û|TøY¨j:Ÿ‚ôëxe&ÚM5LÚ•¼E£T[‹UPÒ>é î€8"&‘–v¥Áfô¦”jû¯ðþ½OÄx›Ã¬nR«^ÖôKâKM×]þÍôWi:é~)µâ•JŒ‡ ×ÐBºgäX¬®¤M­ž¶Œ%ñ®ˆÔiòéžðÍž•o.<é!æ¹Ã;/›3“$›L·{¡°08¯›¯ˆ«‰—5Y_úì~Õ•äØ –—±ÀQP]m»ÝêÝ۵ݮݶZÅbza@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@q~ øoðïź”ZÇŠ¼áÍgWŽl—Ú®—ou2B˜Fа@ÌÇnq–'¹­aZ¥-!&½Ž,V[‚Ç5,UTkù¢¥ù¦x¿ûüÕìíí´­'WðüÑÌ$k½#TšI%P¬<¶&dÚKÈPÙAóc ÷ÓÎ1pwr¿ª_¥‘ÅøoÃø˜rB“¦ûÆNþžó’ü.dé°×Á½7R¶¾¾ÔüS«ÚÅ»~¨_ÄÍ• n0ц\r£9I瘩++/Eþmœx 2çÏ4ºJJÏÿŒ_ž}Ú¤~Êßt]JÛV´øsk-Ô¶¦£yu} Ü¥Nèf•ã~ãrœ‚ÓÌñu+¨þV_‘íḇ°•ZxHÝ3”—Ý&Óù¯=Ï]ð炼àÿ¶Ÿ xKEÑ æÏ´dXCiçìÝ·–£v763Óqõ5ÉRµJ¶ö’nÝÝÏ ÂeØ<7Õ(ÆŸ5¯ËÛkÙ+ÚîÞ§MY@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@ÿÙ endstream endobj 56 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (./Benzoic_acid_2new.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 63 0 R /BBox [0 0 1551 1253] /Resources << /ProcSet [ /PDF /ImageC ] /ExtGState << /R7 64 0 R >>/XObject << /R8 65 0 R >>>> /Length 76 /Filter /FlateDecode >> stream xœ+T0Ð340572S0AdNr.—~¹Bz1W¡‚¡‰™™ž)XÜÐÐÂÄPÏRÁPÏÌØÂÄ B›™CÔ[(¸äsr(¤I†Á endstream endobj 65 0 obj << /Subtype /Image /ColorSpace /DeviceRGB /Width 1550 /Height 1252 /BitsPerComponent 8 /Filter /DCTDecode /Length 200348 >> stream ÿØÿîAdobedÿÛC       ÿÛC  ÿÀäÿÄ ÿĵ}!1AQa"q2‘¡#B±ÁRÑð$3br‚ %&'()*456789:CDEFGHIJSTUVWXYZcdefghijstuvwxyzƒ„…†‡ˆ‰Š’“”•–—˜™š¢£¤¥¦§¨©ª²³´µ¶·¸¹ºÂÃÄÅÆÇÈÉÊÒÓÔÕÖרÙÚáâãäåæçèéêñòóôõö÷øùúÿÄ ÿĵw!1AQaq"2B‘¡±Á #3RðbrÑ $4á%ñ&'()*56789:CDEFGHIJSTUVWXYZcdefghijstuvwxyz‚ƒ„…†‡ˆ‰Š’“”•–—˜™š¢£¤¥¦§¨©ª²³´µ¶·¸¹ºÂÃÄÅÆÇÈÉÊÒÓÔÕÖרÙÚâãäåæçèéêòóôõö÷øùúÿÚ ?ýü € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( €<Æß´÷ÀO‡·ãJñ?ÄÍ-5A4ÖòÙé‹.§-¬±0Yt¶I ,ã$†;[4ð•ê«ÂòüÏÄY^_.LF")ꬽæšÝ5ÛçoÀòOþß4/°cÜø‡ÄÂã˜tM)¢û.ݸó>ÖÐgv㛾áÎÞ3Ñ «=Õ½_ù\ñ±<{’áíÉQÎÿ˧þËø\óßÿÁF<„2x7ᯈõ-LÌ–úÜöúlKÖË #k‚[pQ·`w w†KY¿zI~?äy8Ÿ2êqýÅ)ÉùÚ*Þ©Ëî·Ìã?áäzýÄÿœÿòký‡/çü?àœ?ñ¨ÿÐ/þOÿÚÿ‚‘ê?ôC#ÿœÿòØrþÃþÿâ)Qÿ Wÿÿö¤ö_ðR7këõO‚RA¥¼È·7ž!ËE†öHÚÕ°\¥Ð,¹ÈRÉ&–“ü?àšRñC )%<;K­¥woNU½zž¡gÿø)segsáŸÙ[O2E%õÍ…£El¬ÀGrîUAÉŒØ Nç–QˆJú?Ÿü×¥â.ORJ/_«JËÍÚMýɳִoÛöl×u[]Ïâ¤w¶KªXÞiöëµK÷$Iœna“€2Hšx LÜ?_ÈöpüY“bf©ÓÄ«¾÷Kïi%óg»xgÆñ­„Ú¯ƒ|S¤kÚdSy/4[è¯"IB«/0 ÐíÎpÀ÷Í(JÒV=Êš8¨óКšÚ馯ò:*“` € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( ”¾2þØŸ¾›ýA¼Qãx7Çýƒ ºÈ-æ_5vÝ\«ƒű×-2o å0®Ü>¶"Í+.ïúÿæ|ÆqŹnOxJ|õÙŽºë»Ùj¬Ö²_Ê|âÿÛ÷ã‰N©kàýAðžqå}–ábmFúÓnÂÿ½—>â®9·á_æë×£“SVsmþ üÿó¼Çļ\ù£…„`žÏâ’ù½5ÿÞzŸ0x£ÅŸ>"ùëãÏkÚí¬·öFúY-aœîùâ·'Ë‹GUªXª€8¯VŽ•/‚)˜ñN?uˆ­)+Þ×v¿’Ù|–†$E 6`+©R>zyƒ}MH´(ÀûŸ¥h©ÓÇ7Ô¾š$`«ý*•4sËû’ÿc'üòý)û2~¸û‡ö2ÿÏ/Òf\}ÈÛENñ~”:e,cîQ—DŒƒû¼T:HÞ8×ÜÍ›ÃèÙÂ~•‘Ñ {]L¤ÑfÓo¬õ]6Ym5K9’âÚòÑÚ)­åF ’#®YXAŠÆxxÉY£ÒÃfõhÉNœÚkTÓÙž¹á?ÚCöˆð ÷ºWÅ kR‚I¡–âÃÄÓ6¯ ë'ËÌåž%pÌÂñ±|ÙU#Ï­–P¨¾zh}~]Ç9¦WuœÖ—R÷¯nšê¼ígæ}¿ðÿþ 7ợg§üUð¡£\·Ùa}_@_Z³·Ë<ÒBÛ%†%8`‰ö‡ÚHä¨ßäVÊ*CZnÿ×õØý-ñˆ´qppzjµ^nÚ4¼—3ý~Ýøyñ¯áGÅx£o‡Þ=Òu‹§†Kƒ§E7•{I'–Ï%¤›fw•;”Œ†R|Ú”*Qøãcí°Y¦1WÂÕRëdõ¶Ú§ªù£Ô+#¼( € ( € ( € (Æ5OÚ?öxÐõ=GDÖþ=|:Óõ>y-nì/¼S§Ã5¬Ñ±WŽHÚPÈêÀ©RjH-‘Ó&iJ4¤ÓòeøjOÙ—þŽ/á‡þÚoÿ¥íiÿ2ûÇõWüú—þÿÈ?á©?f_ú8¿†øWi¿üzŸµ‡ó/¼>£ŠÿŸRÿÀ_ù•àßxâ.™>·ðûÆš‰ôh'kYoü=¨Á¨CÁUŒm$LÊ+£'8u=ÅR’–©˜Ô¥R‹å©Ÿš±ÖS3 ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € (çÏ‹¿´ÿÁÿ‚ï6Ÿâ›ï¦ßø¦ô%[»åÏ”x»‚CòL²9ãÞ ”ÜF+ª†¶'àZwèxY·åù2kRòþU¬ºtÙhï«W[\ü¬øÓûXüTøáö¤G bþf•£ÞJÓ_#Â#xîîÏ:/š_Ý„D"@\¢°ú &U /šZ¿ëcñî!ãìVeFîéöOWuf¤ôºßD’×[ØùóOðâ"¨(ô½˜Ñ?5Äf-½Îª×BUÇÉ[Æ‘åÕÇ6tú(ãå­U3‚¦3Ì×GQ’´TÎIbßrìzJÿr©S1–)÷-®– }Ú®C‰}É—þÅ>A}i÷éƒþyŠ9õŸ26ÓõJ\…,Kî@úRwOÒ—!kû”¥ÒPôJ—LÚ8·ÜÌ›D8Z‡Lé†6Æ=΄0r™JÎTŽÊxï3š¼Ð#pAˆp+R=*8ù.§?m¦k>Õmµï k7úF½k¿ÈÔ´«™-n Ü¥d¨C.U™N!ˆèk’®5¤®{ŸVÁÍT¥7.©Ûò?@~~Þž&Ñî—ÃÿàþÒÒßbAâ&É#¹…Úc¹®àB¨ñ,n>hQ\qåÊÏ•ðqY;^õ¹þŸðOÖò!QªYžßÌ—ŸÚK§øUôÙÜý*ø{ñ'Á|:ž+ðˆ!Õô&šKfž4’'ŠT?2IН`«ê WVVR|Z´§F\³VgéØ,~2¢«áf¥Õ~©ê¾gqYa@P@'~)|2øký™ÿ â/†<+ý¥æ}þM^ÛNû_—·Ìò¼ç]û|È÷mÎ7®zŠ™N1øiP«^þÊVì›ü…¼iÿYý’Ÿ4–V1´‘2±BÈŒTœeöq¯(êŒ*å4+.ZMy¤Ïð_íµû\xûOû ãÏŠ.¾ßåù¿ð‘ͽ³fìy_nY¼¬ï;¼½»°»³µq´qµc´6· àk[š’Ví§åcÜ<ÿNý®¼)ý§ý¹¬øgÆ?jòü¯øI4HáûÝÙò¾ÂÖÙ߸nó7ýÅÛ·æÝ¬s ‹{3ίÁø9Û‘J>üî{÷„?ಞ>°Ó'‹âÀÝZÖLìÑ]xXŸG…!Ú #C,wLÎ9.$†Q´m%·ŽcüÑ<ºü¯ûª­/5ÊÇÙ>ÿ‚±~Ê^%Ôî,5³ã/ ZGLº—ˆ4eš\2‹)n$ÞC L#eÚ¦8ÚRòéòGOáÏø)WÄM;Ož?|Ñu}PÌZ;S›J‰bÚ¸FŠHîI}ÁÎðà@Ú0Ka<ý™žĈ¸Úµß“·àÓüÏoÑ?à¥_nÿ°­üEàïè÷—^B_N¶¶×vš{¶Ñ#y‹0–H–;–ì«‘NÚåžYZ7µ™ïáøë,­Ê¤¥í}Kñ»KÒþGÔß?iŸn"±ðĽPÕ¦šKxt›‡{Û†Hü×1ÚÜ*M"ËoT+ò·?+c’¥ ”¾8ŸG„ͰXí0õS}¶}övíµ‰èP@P@P@P@P@P@P@SÔu?HÓïµmZúÞËK²…î.o.åX¢·‰³É#±UTXši6쉜ãN.svKVÞÉ—¿o«Eî<1û>†H?ÑÜøÞòß–êòEog<\Ë42Ê?ç¨Xþäµí`ò—?z¿Ýÿü¿‰Z®S'\œiÿìÓå3uÇ‹öiò‹Û‹ö ÿ£”=¸Ã§ÿ³K”k@öìÒå4Uʯ§ÿ³IÀÒ8‚Œ¶å¨q7s2k¿-C‰Ó æLúj¶rµT1-u0.´‘ƒµk)@壘}NVûH 2d{ŠÂTÏR†.Ú¦fxRñoÃízxÄÚ&»Ð.l&1™:IåÈ>ì‘ Fà£mW|$+.Y«£éò® ÄåÕ\=Gyuòkf¼ÑöÁßø(Œ4GLð÷Ç+u i„rø³O€[ÝØ£ ’{h—ËAh—¬L¨ŒvÌçÀÅe·•¸ýo!ñ Õq¥™%göÖ–ßt´}6¶‰îÏÕýÄ:Šô›MÂú柬hW[üGJ¹Žê ¶±FÙ"­†VSƒÁR:Šðåi+3õ:Uiׂ©JJQ}SºûѱHÐÁñ7м1à­÷ÄÞ2ñ— ønÏgÚumjò+;k}ùdeUÜîŠ2yfrE&ÒWeB©.X+¿#óoãWüsö~øqy«è4íSâ7ˆìð‹q¥2Yé/*Îc–3{ gm¨"É Å h¾™9jc)ÃE©îàøs‰´§î'ß»üÚgåGÆø)?íAñjïW´ÐÑçmòÑÚ†7TÿT¡Ü7\t嶈úÜ ᨤê.yw{}Û}÷õ>ÔnµoSÔu½oPºÔ5By.®ïï¦i¦ºšF,òI#ÎìıbI$’kŠU[ÕŸKG iF*É¥¸ô¬ÜÎèa—bÂÀ=*ΈáÑ(‡Ú¥ÈÚ4 D>Õ<ƪ€ñµ.cE@p„Òç)PÈ£œ¯«‡‘G8}\<Š9ÄðãLÔùÉxq¦ |ä¼9·>”ùÌž‰­ýª”Ì¥†ò kl犥3žx[ô+IfªƒZ*–9j`”·GØ ?o/Ú«á·6­kñGTñeÆ>Ó£xöæ}jÚ}©"¦I<èpeßû‰cÜÈ›÷ªí®ÊxÚ{ßÔùÜo á1²‡+ï?à}韬Ÿÿà­_¼Y¦%‡Ç}*ëÀ~'¶€4º•½Æ§¦_º¬@˜ÄH÷»»LÂ&GDHÆgf W¡K ¯{F|~;…ñXwzü~æ¿OŸà~§xgÅ>ñ¦‰eâoxK×¼7y¿ìÚ®y嵯Çd}’ÆJ¶×FSƒÃ)k±5%t|ÝJs¥' ¦šèôfí2€ ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € (築ŸµÁ…Ñ\Eªøª-_]†Y m ÃŒ—×i,r*H’Á!d,I:±Âîe+]”0ñ l»½õè|ÞkÅ™NNŸ¶¬¥%uËJWNÍ=lšþó[;]«ø¯þ ã›ëåO‡Ÿt?JŽYŸÄ’Ky-ÜYSyp´BÚ²ï”e€ òå½z9k÷²û¿¯ò?;Ì|W”el ’¾³m¶ºhš·š¼½t×çgö„ý¢|ScŸ«üVÖåÒcƒK° 0eµHÜ®ü¥Š’# éÒÊpÐwPûõüÏ…Çx…b£É,KJ÷÷m÷Å'o+Øñk A*ôUŽ©šN]Mx¼>Š?Õ=…h©’Ç·ÔºšùgU쌞9÷&(ÃúSödöjÿ¡âþ 4ßþN¬þ½KÌìÿU1Ýã÷¿òø|'ìÓÿBÄÿüi¿üGשyýTÇwÞÿÈ?áðß³OýŸÿðY¦ÿòu?¯Róú«ï½ÿ‘sLÿ‚¾þÌú¦›awáˆÚm¥ÍÄpË©^éVMš3eEvò@K;àªÇµ¤û™Ï†qÐW\¯Ñ¿Õ#è/ ÁC?c_ë–^Òþ8é_ÝoòåÖ´ûý*Õv£9ßuupÇÂ7¸ÜØQ–`«JZ)2Œu%yR+?ÊçÒ~ ø§ðÇâ_öŸü+ˆþñ_öo—ößøFõ‹mGìžfï/Íò]¶nòäÛ»ØØèkU%-™ÃRJVö‘kÕXï)™…P@P@P@P@Îø·Å¾ð'†õø¿XƒKðÞ— žêúä±®@ ff*ªŠ 32ª‚H¡ T’ŒUÛ1Äâia)J½yrÂ:¶ÿ¯¹nÞˆü'øýûHøßö†ñåµ­Ö¡¢|)‡÷6^IÊ}µ«‰ï•Ùe/0S¹"Úe·É'Ô`rèÑJRÖ]ÿÈü+ŠøÊ¶e9R¢Üil•÷ó—wå²éÕ¿/Ò4TP,`c Å{”éØü¯Œrnìï¬t¬m%y®¨Àð«â®uvšv1òÖñåUÄ\è­´ìãŠÕ@óêb ¨tð1Åh qÏjçîÕ¨³ÄÒÀv­DÁ×,¥ˆþí>S'\l‡M´ùIuIE†{Så#Ûˆl@þ9F« ûþí.R½©X³G(*åw±ö©q4bœšx?ÃIÄÚ5Ú(K¦¯÷j ãˆfEÆš9ùx¨p:éâLK3¯ËY8´ñ& Ö˜¼îJÎP;©b_Fr·º>ìíZÂTÏNŽ.Ûœ>© ‰OÇÍ:W=Ì.;—fz/À^8ýšõ}R]"Èkž Ô÷I}ᛋ“o—p—ɵü™FY‚0tX±´~6;.Ž!]hûŸ¤ð·VÊ%É/~›Þ7¶½ÓÖÏ¿uòkê?ŽŸðU‡>ðf“7ÂßjzçÄ]X\§öWˆ¢{4 –9®]7­ÆçòØCœÇ¿|°¶Ðß!æÀ>Y­_ÜEð§°âÊn¾vŒZMi̾WÒëgªõi¥ø1ñWãGÅߎúä>!ø¹ãÝSÄš„û4wn±ÛYnHÑþÏkX`Þ!ˆ¿–‹½”3e²kÁ«ˆ”Þ¬ýg“ÑÂÆÔáoÏï<ê;P;W,ªí,"EÄ·qY¹°ÃVéY¹Q ‰„5.GDh“,>Õ.FÑ¢J"©æ5TGˆÅ.cEHpÚ—1Jï+Ú—1^È_/ÚŽaªBùtsÙ ò½¨æ²/ÚŽa{!†?j|ĺCLtùˆt†½©ó阇¥W1“¢ˆZT¤c* öªS9å‡+=ºžÕ¢™ËS ŸCÙ~~ÑŸ¾}½>üIÕ4Íí>š+»'‘ü½Òý–á$„LD1/šÌÚ»wm$ªX©ÒøYácò.;ZÔÓ}öz×å±úùðþ ë kºž™áßÚÁ–¾‰à¸køy®nmÁ‹D§ì’xÐÇòYf>`S±QÉÓ£˜FNÓV>1á Ôž\ÞNÉýû?¹Ÿì'†|SáŸh–^&ðwˆô½{×›þͪèב^[\lvöK*Û]N ¤A¯A5%t|…Js¥' ‰¦º=»L€ € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € øïâí©ð·ÀÆM7ÁäøßÄCoîôyÕ,cÏ–ß=î[(ìG’²üÑ”}‡šõ0ÙM|F²\«Ï»üì|&yâS”^¥íªv‹÷zo-VÏì©j¬ì|ñ öøÝñnÇû'[ÖàÑ´ aò®t¯ G%œ7y+ù®Îòº²HU£/åªJddý(£AóZï»þ¿àŸŽgÞ"æy¬]'5NG]_u«»néÙ«ò½4¹ã6^Ž0 F?^´hØüö¶få»:[mF>NkeHóªcŸsb- |•¢¦qË~¦„z?ûUªfÆy–—Gݦ©™+j—ž´ûKáß0Õl…µ¶Dv±$ÛšÚ„ÆÂÙ¢b»pÀ¢é§Šœzž/ Â×»p³×U¦ÿŸÎçéïÁ_ø,^¨ÞhúÇÿ†¿ØÞnc¹ñ_„¥{‹häiÀF{ 3,p¤,K²M<…£ù";§mgÃu)^Te'þð©úÿðãâ‡Ãߋ޵ñ—Ã?i~#ðÜûWíšdâO"F%ò¦O¿ Á%Œ´R‘7Ê×)+ÅŸ=VJä©3¼ª2 ( € ( € ( € (ž¡¨Xi6Ú®«}oe¥ÙB÷7—r¬Q[ÄŠYÝ݈ ª ’Ä€$ÓI·dLçqs›²Z¶öHüý§þ=ê?´¦±Ñ5[†øE¢LdÐ5¸»”&×¼™ %˜È#ܤD ˆï.ï¨Ë°>Æ<Ò^óßüÁ¸ÓŠ^cYÑ¡/ÜÇeµßY?Æ×ÙtM³Éô!T& ^í:gå¼[wÔôm7L •®È@ùìN&çai§ƒŽ+¢1<ŠµÎ–ÚçËZÆ›R¹¿oc€>ZÕDá©Zæ´9#ŠÑDäsV;,cеžUK±Ùçøj¹L%T²-=©ò‘íG-Ÿ=(åT—ì¸íNÄóˆmíE†ªXgØÿÙ¥Ê7Ti´ö£”=¡Ùÿ³G)J±NK1éRâjªÜϖϯ&ѪgKg׊—¢5Œ¹ìן–¡Äé…f`ÝXgÜÞh2\k^:Š%hbótvŒÜL~H”•Lš@²£ˆÙH'¿ —VÆkh÷§õo3下ŒòÞ½:Òç«oy¦×3Ù-»ÊÍ5ÌOüuøÕñZyá"ñdú~4Oh^i,lÚ9#D‘C™[a$Lò½ÂíV"¾« ”СgËwÝëÿ ~Ÿø…šf®Q•^H;®X^*ÍY§­å~ͽݬŽÇÃÑÆ÷cèzñ¥cóªø÷.§Uk£’·3Ë«‹¿Sv%xùp+ELáž(Õ‹L-h sK_NQ–©@ç–!²ÒØJ®S7\™l÷iòëûþí¤û`ûþí£öà ‚ÿvŽPöäMb=)r–«•žÃÚ§”ÑW*½ˆÃK”ÕW>OñßíOðÓÃi5·†_ë #Äb² ²2:©-pë†R h–Em½@!«äs.À`Óí%å¢ÓûÍ}Í'{|Ïè~ ú;qwÎ5s(¬“¼í*J-«RŒ®švSISqæÑ6œOмcñ»âoŽã»´Õ5Áe£Üýý3IìñØQ¶LŽŒ GvROLçù‡cñéÂSå‹éÖ·vŸTÛ_ý}Áþp— Nž"†Ú׆Õ*¾y_™IIGJq”ZJ2„#$–÷roÊ£´¢×Ï:‡ì4ðit--¾;T9ÃX˜AíQÎl°ãÄ>Ô¹ÞOµ.b½€žWµÁìDò½©óìF‡¥>b3ªæ3t CíT¤a*w‡Ú­Hæ»Àjµ3–xtÊr[Žx­c3Цv.ø^ñ7‚õË/ø7ÄZ¦ƒâ[-ÿfÕ´[Élîm÷£Fþ\Ñ•uÜŽêpFUˆ<[«‹ºg•ŠËéÕ‹Œ¢šó?`f¿ø+‡ŒôWFð—í3¥Úë^¸¸XeñÖ‘n-o4ôf”™nlâO.á¼ ˆ'HãvÛ<„)ôibï¤ÏÇðó…å‡û¿Éÿ™û·à?x?âwƒôx_µÖ¼!­[‹›JÐ’¦H ©‘Õƒ#Æà::²°VRjjJèùŠ”åJNVhëiP@P@P@~<~Ý´xç_¼øá5ÿŠsA¾Š]wU‚ïpÔnÑr-c}¦(]‡˜$Ëyñµ !¤÷r¬ÿ}/—õýh~QǼJ£|¶ƒÑ|Nû¾Út]oÕt¶¿hzJÆ‘¨^kê)Ó±øN7äÛ¹éú^÷x®Ø@ùœN îlì~è ]1‰âV­Üê­l±–¶ŒO.­c¢¶´Æ8­”O>¥Sn NœVŠ'êšðÚtâ­Då•Rò[Ž*Œù›-,jJz«zQp°ížÂùEÙEÇÈ?Î(¸r0)EÑØ=)Ü\¬iŒc¥³!x»Rm^Ñ +"ÕFŒÙí8ÅK‰¼*]SXç ¨q:aXÇžÇâ³q:áX¹±¿x]]ìØþêfG¡÷¯_jü‹9Ê*åU{Ó{?Ñùþ{®©¢^x‰‚ã춆2šýå?ÞÕÁ¾š¸7Ë&ïKžTö¯³õ(Ó& RÙ´`J±ú ›š¨ˆé6Z(Ú•Í t®h H#úÒ¹J„^ß+•ÇJ.>@òù\|‚ù^Ô\\ƒL^‹‡ õ€Ã;“È0ÇNä8Ç¥;’àFÑÓ¹›GíNær¦BÑÕ)Ê‘ GíV¤a*D ôªR0"¤ûV‘‘ÅV€ËGFÔ´ýkEÔ.´ýgOž;«Kû)š­fƒ$‘Ȥ2:° H €EtB«‹º<¬V¢á5tÏÞOÙþ £x©‡¿j CLðÿˆGÙ Ó^~•Óg‰[s¥¶Ò€ÇËÍl yµqFÜ:n1òÖŠñ75!Ó¿Ù­iâ ôÑýÚ¥žX‚ÚißìÕr™Ê¹diãÒŸ)“®H,?Ù§Ê/n;ì éG ½°Ç³P8œJ[‘ ,õr”êkv£”cÃ>1ülð7Á»]nçí~)žÙ®,4 lù·x` »DQ–'ç~¡`vRµág9î%‡ïê5u»éò^o³µÚ±ú§†¾ñ‰˜”²ê|˜XÍF¥y[’s4•Ó©4¾Ä6r‡;„d¤~XüPøáñâÍíôz¦§-‡…%”´²“lÇ”*²[t™²P ;Gä™Çã3YIJ\´úEmm7þm¯¯]’ØÿC¼7ðK‡x*”(ª¸Ä—5y«ÍÊÒMÁ6Õ$Ôœm 7 )Êms?(ŠÔ(ór©söÊ8E‘q-ý«'3º{VéPäuF0‡Ú§˜ÙQ°ñµ.bÕÞWµ.bÕ!|¯j9ƒÙ¡¾Qô£˜^Èi‹ÚŸ1.õ>c7HˆÇUs'H‰£ªLÊTÈZ<öªLç2³ÇíV¤rΑYã­ŽYÒ)É5¤dqU¢™BXAàŠÚ2<ê´SZž‰ð§ãwÅÿ€ÚäÞ!øEãíSÃZŒøûLv޲[^íI>Ñk hgØ&”§˜±›rá¹®ªU¥ ™àã²ÚX…j‘¹ý~ÃðPö3ü>øi¥øoãtlöö6ã²×í—.ZÌHîë4H?y;1U2¡+æ,>ê¦O‡Ì2ÉàŸ4uåê~–Vç–P@P@PÌ_µwLj¾ü3¸¼Ó\¿Ž¼@eÓt(¢’öó؛Ǝ@Ûâƒ(Äp]âFÚ$Ü:ðxg‰¨£Ñn|ÿgPÉ0R«öå¤vÞÛëÑzoeÔü+ðÆ´PƈP8Å}¥vV?˜ó?^힃§Ùà/Õž"±ÙØÙãÑž=zÇMmkÓŠÙDójU7à¶ @"´Hâœî®k[ÁµðGióÑ¢ª; «ö2JãÂs‘Jæª:4®5â<ԹƕÉD^Õ<ƪˆï+ÚŽaû!D^Ô¹ŠTA¢ç¥ A*$f>¼Usºc tùˆtÆÅUÌ;2 d8د$¨%6ŠR[JV4S3gµÈ¿-fâvB©‰sh9›‰ÙN©Ëߨ‚ °”ON…{eí‡-ò×<¢{kœN«¤£«¼×<éÜö°¸¶™âž/ðµ¾§m=¼ð†V?_­y8Ü”\—·4îK„úS¹›CT™›EíNæn-µUÌ¥L®ÑÕ)J‘]£«R9§H©$^Õ¤dqÕ£s6x7gŽkxÎÇ—_̵?Zÿà›?¶–©à¿Ù|øµâ-{V𯉮,tÏ ]ÝÌ׉ ^`[Åhƒ"ÛL<ˆÐ+yp¼k„U–YÙÁb®ýœÞûšqFB”^/š»’Úë{ú­|ßÉ#ú¯Xüü( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( €<ûâ7Åü+Ñ&Ö¼a­Cl|©$µÓÑÔÝê,…AKx‰FÌ‘‚~êïÊ®Xo‡ÃUÅMBš¿ä½O'8Îð9âqµRNËíJÝ"º½W’½ÛKSòâÅï|qÔ̾&»û/… ºk;öØòlò¡f4Òç~…äØX­}¶+¥„WJòêÿ­åþ,ã¬wTq©.ZIÞ0[.š½äíÕ÷vQNÇ7¦èˆŠ 'JöaLü×nú•ž” /5Ñ=lSgGo§ÇËÍl yõ16­ôþŸ-h¢qι¯ †q‘V¢rJ±¥Ž: µ V.¥šŽµJ&2ªÙam”v§bÙ …aNÈWc¼µô£@ÔC šVC»"k`iX¥6†}˜‹E‡Î|9ûDþÖÚ/€Î½à?‡gíÿ`żڦĒÏJs¸H9'͸lÚQY¾bJ’ž"êAíY¹УbÂÃíPätF‘:À}*y•"aœ!â ö¥ÌZ¤;Éö4¹‡ìƒÉ>”s³ÈÍ;‰Óð`t§r2;é´^Ôîg*d R‘„©4~Õiœò¦@ÑûU¦sÊ™UãôjG%JE7޵Lâ©L§$YÍh¤qT¥r„±uâ¶Œ6­"+íOCÔôíoDÔn´íkOž;»=BÆf‚{Iã`ñÉŠC#«Á®˜M§txø¬4fœd´?¢Øgþ Y¦|_ºÑ>||Ô-tß‹—×dÒ5»{%³Óõ ±@±E+ù¤-üÒý¡‚¬qBß"G‡d½J5ùô{Ÿ˜å Üéü?—üõæº( € ( € (ùþý©~&éÿ~Ä ô«R9¥A4ejÔ®a:N;²gµQ‹‰]à·çA7h͸µëIÄÖ,s×V§ž+)#ºC›ºµ<ñXÊ'¡J©ËÞÙ5Œ¢ztkV¡fFî+žQ=œ=cÏu48bšä© ŸA„Äòèx‡Œü+m¨Z̲Ó׎ª¼=ëÄÌòê8ú.etþôû¯?øg¥ÏÓø3.Ì©æ9mNYÇFž±”^ðšÒñvòi¥(µ$šùzêÆ[©­'ÎŒààäàþUø¶; <"xyï÷®æµ?ÓŽÏðüW“a³œ*´+Fö×Ý’mN7i_–IÆöIÚëF†,uÇsèÔK J Q-$YíSsEÒ@=)Ê\[~œR¹J%„µÏj.R‰qlÉv•Êå%_ìÐ>Qÿa'µ ål}©‡)Y³EÅÊWk/cEÅÊV{OJw)UíO÷i܇«Ûcµ;’àU{|v§s7£ÃNænV‹ÛI™ÊvÔU\ÅÀªñâ©3 À¨éZ&rN™RXÁ´ŒŽ*´“FLð]‡SM4FßðN¯ÛOMø¿á=à§ÄÏÝIñ·D‚E¶¿Ö&WÚ!gWŽL×0Å…‘tŽ‘yû¤&o/èpx¥Z<²~òüOǸ“"–]Uפ¿u.ßeöô}>î×ýJ®ãå‚€ ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( €>tý ÿh-à¶Š––i¥ñRˆ¶›¤1%b\•ûMÎ+ € #)U xý ¿/ž6}¢·¢óüâî.Ãp¾¼—»ýº]¢¾ù=V¿(5½kÅßµæñW5¹õmuâH>Ñ2¤a#Aò¢FQ%Ž@,ÌÇ–$ýÆO JjÈþXâ%Æg5Þ#QÎV·d’è’²KÑnÛݳOÒ@ÚJþ¯J4ÏŠÄbïÔì­4ð  µÑE\EΖÛOÀVÊ'›R½Í¸,@Á"´Q8çZæ¬V0µj'<ªQÀæ¨Æí’¬tб(Z. #¶ûR¹\³Ú‹]¾Ô\9ÙíEÃ6Qpä?.i/ÛT¼Õ.| ðW[û6‘mæC¨x¢Ók=ó•(c´rÈ×$ùë‡fÆÊª_˸ŸŒåÎð™dì•Ô¦ºô´_D¿™jßÂÒWÞ}ðï ÿŽ0Üõ'Ë*Xy]($Ô”«GNiJßÁ•㶪ÆR“…?ψ-@Šüºuï >#R8@è+ Hõ©P±v8}«'#¶l\X=ª\Ž˜Ò-ÇmžÕ7TË«m‘Ò—1¢¦J¶g®)\µL”Y{R¹\„¢È qEÇìÆ5¨ô¢âä 6ØíNäò¼ÔîCQáÅ;àWhý©¦fàWxÿ:¤Ìe«¥ZfY’­3–p+²U¦sNYc¥h™ÇRµLà©”©œÖ±gZft±ç5¼dy•i_B½•ö§¢jzv·¢j7Zv·§\Gwg¨XÌÐOkÏ㟖Ò4&m“[†_ô‹¤Û"H¾TDí•7lšH7 5v`pþÞªOe«>oŠso윾rƒµIû±ï®ïtô]VÎÇâG…´¼,D¯Ê9Å}¥Ì™ž&ížÛ£Ú´â½*q>/Vç¥ivc q]‰ó˜š§ocl>^+¢(ñkT:«hvíâ¶Hóg+ *ªv8¥«,ªæ“eÆ7'T¨lèŒ {T94éܺtâ²r;©Ð/G{VR™èRÃß¡qm½«'3¶_"ÜV¹íYÊ¡ÛK ä\YíYº§lpC¾ÃíKÚ—õ!ÿaÈéKÚØ¥—ÝlFÖ?ìÓULå—ùd³ÀéZF­ÎZ¸-Š2Z{VÊ¡çTÁyžÛnx­îpÔÂÛ¡, OJÞ3<ÊØvÞˆªð<е+œs¡Êõ+ºb­3žp±UãÍYÎÕ™™=¶rqI«— Øçï- ³’;iT9[»^O„¢ztªœµý€`Çmc(ž ö8NÄ ß-rÎ'»†¯sÌõ½7!È^+ޤ¥ÁbvGÌŸ|0ÈÇR·NPaùþOéþ>Õð]“}f—×)/~ ]~Ê»5¿M/»²?®¾ŽÞ$¬›0ÿW1òÿgÄÉr{·j¼¹cµ¯,ÒQwR´”»yT‘úWæ ŸÝ‰Ò*’Ò/E8â•ËHÑŠÜqÍ+–‘£¡=E"’4"²ôZ ±¡‹ R¸ìY]5Ž2(¸ìL4ÖþíQN”ç·\|¤M¤¿§éEÅÊV}-ù¢âå)É¥?÷iÜN&|Úk'nh%ÄΖÁ½)Ü—Œ– 3Å;’âfËjõ4ÌÜ ùmÈÏW3p(I\ФÌe£Ç×Ò©3 D¦éŒÕ¦sÎ7ZÑ3Ф ÇÖµ‹<ú´Í?øÏÅ¿ ¼[¡xóÀzõÖ‹âíqsc©ZÁAWFRÈèÀ££2°eb]®œ”¢õ>{3ÀÓÅÒ•*±¼YýO~ƵN›ûV|,\iöºOt9×Oñm:º$Å%ÌXÈ¶Ó Û<ÁñÍi<£#}&²¯n§âÙ¾Y<¯ìž±z§úz¯òz^Ç×µ¹å…P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@PŽ|oø¿¢üðeæ¯us xšò)aÑt×S!¼º ò–@Ê|”%ZFÜ0¤w2+v`psÆÕPŠÓ«ì¿Ï±ó|SĘnÀKVKÚ4Ô#¿4­¦—^êÑÉÝYi»Iþ7Í6¹âÝwQñGŠ5õ/jRù÷7·Ý#`ÀÀUUPUB¨_ a°Ð£+$ çyÞ#2ÄO‰›”äîÛþ´Kd–‰h´;};L)ÙÀö¯F>;‰¿S³³°/Ë]‰ãÖ®tÖ¶8ÁÛZÆ'V±¿oeБÅj¢qN¯bòÂ3ÀéLÎåµ@(’4®h H#Í'#ELxЧ˜ÓÙ{Ræ-Rågµ.b½ˆytsÙ ³ÚŽb]3ò‡ö®ý«‹§ð·án¥ÿ·Í¯¯Ú¿ü…{5¼ ?åߨwë~èýÖL¿•ñgýc›—¹´¤¾×’þïwö¶^ïÅýõô|ú=ÿdºg»þ¿¯Sñ?³/mŒtbýÚjÛÝ_vüŸGé¯eäž´ WÒÒ‰ø–>­äÏYÒmŽÔ8ë]ÔÑò¸ºš³Ò4è0Š1]GÎâ'©ÙØ[p Ñxõª åFkDqÊZš¨¼L…²Ò%CgU8’<ãŠÍ³ªîhCN+Lô¨a̓§ƒ™éÓÚp[gV™êáð·5#´ÏjÁÔ=zx;ô.ÅgÏJÊUNêX-v4£²ã‘XJ©êÓÀé±`iùíQ펅—_¡"éçÒ“¬i·ÈkiÞÔ*ÄÏ-¿Bœºa=«X×8ªåMô(˦à–µ{ž}\¯•ldO`F~Zé…cÆÄeÖèeIg‚N+¢5O"¦Ïc2âØsÅo žN# ‘‘,X5Ó-j6)ºV‰œ3YÔw«0qh˸·Ü “W*3³9›»N”¢wÒªr·°pÃŒ‘éÑ™ÄjVƒW4â{Xz¶8JÈÀŽ+–q=ì5nÇx—JWŽT+ò°5çÖ‡CërÜSM3å}WKm.úkb>L’½zzWâ9öTò¬[‚ø%¬wÚûkÕz½,úŸêG„¼}Oòbj?öª6…TÜnåÊ¿x”mhÔÕ¯v)IN*ê7uâ$W†ÏÔ’5"‹§%¤jÛÀN8 ´Û{]Ã¥&˱³oe»qH¤hôþAű±˜\–‚¬[þÇoîÐ,Å£“ÁJaòh§%å3[D}Ç÷t Ä2è®vs@XùÑXœ• —2m`ÎÊw)‹q§uiÜ— çOÁ¼VÑg™^™÷/ü—ãî‰ðöƒH¼i®ÿeü?ñ•ƒèÚ…ÝÝëÁecs¹dµº•m®wÚ"[¹º p}luNv“ÑŸŸqfY,^ž”o(;í«]RüüíkÔ…{§åA@P@P@PÕu]/BÒõ-s\Ô­tíN·’îóP¾™`‚ÒÔ»É$ŒB¢*‚ʼnI£a¤äì·<_þ—öd=?hφøWé¿üz£ÚCù—Þt}KÿåÔ¾çþBÿÃR~ÌŸôq ?ð¯ÓøõÖ̾ñýGÿ>¥ÿ€¿òøjOÙ“þŽ/á‡þÚoÿ£ÚÃù—ÞQÅÏ©à/üIðo¼ ñLŸ[ø}ã]Äú4 k-ÿ‡µ(5cU\ÆÒD̡º1Rs‡SÜU))j™…JS¤ùjE§æ¬u´È ( € (Äþ*ð¿‚t;ïøÏÄš^á«-ŸiÕµ«È¬í­÷ºÆ›æ‘•sº(ÉfrE&ÒÜq‹›´UÙäãö¥ý˜ØehÏ…ä{x¿MÿãÕ.¤òGDpX™j©IüŸùý©f@2hφzŸé¿üzkö—Þ7ÅE]Ò—þÿÈö+UÒõÝ/M×4=J×QÑuxîìõ –x.à‘C¤‘Ȥ«£)  нÎfœ]žåúP@P@P@P@P@P@P@P@P@P@P@P@P@P@P@GÄ?ˆ~ø_á{ßø¶ûÈÓ !"†0kɈ%a… ¤l €fbª¬Ã|>¦*¢§Mjÿ«³ÌÎ3|&G„–7+B?{}#Õ¿ø-¤›_‹:ÿˆüWñ?Å7Þ6ñ­÷Úµ{¼*¢°ÚB )(IÙäàd’K3ff? àpTð´Ô ¿àúŸÇ¼SÄø¬÷,N*WoDºEtItKñÝݶΓKÒÀ H¯V>‰¹ÜYØ”âºcÄ­\ê­lÀÇ´byµ*›‘@Ö–±ÈåÌ^UÀ‹’•É•)\Ö4ÉÖ*‡#xÒ¹aaö¨r:c@`Ïj—3¢{–ÛÚ¡ÌéŽZóÒ§œÑa|‡ý›Ú—9UÛûS矘_·?ÇëÛ§ø!à­R{iÚ,øžxáhÙ£‘âµIIû¯–—jà«"o Ê•ùçñ©ß.ÃÊÏíú4šŠ~kYyY_âGö/ÑŸÂ8Ö¸Ë9¢§ÿÙ“i®hÊJueo.ZWwRRŸ"j”ÏÌûkp0q_•ÔÏï¬.Ú›0ÂN8®yHö)Q5`·ÃŠÉ³¾Íh- ¬Û:㣱ÓKc PÙÓgQk¢³òTÜÕ@ë´ï 3•Ìg˜¥sE¸´ðÀ¸ô¤5Mh¼,N?wúR¹|¦œ^ÀÏ—úSZŠ~ê <-‘þ¯ô¢ZOTd\ød á?JFœ§?sáÖ\”Éq9Ë­.w&? w!Ääµ 0(l.)ÜÍÄåní@ªLÊQ1.,öƒÇ?ʪæ2‰,EIU&c(”$AéÅZg<âQ’>µiœ³MÖ´L⩤‹ÖµLã©>TëZÅžuXdLƒ[Ež}X\Ε:ÖÑg—ZTñõ®ˆ3ÈÄS¹ú¥ÿšý£¿áYücÔ>øŸUò|ñoöÚ§Û –·Ÿ+nùV4ûL{ ;Qä–T³A€+ÐÃTוŸœáokªü¿¯Ôþ—k´ù  € ( kÆ~)°ð7ƒüWã]V ™ô¿é·Z¥Ì6j­4‘AJëfU.U°ÆHëU¹ÉEu2¯Z8zS­=¢›~‰\þi4«Ý_ÄÚÆ­â¯Ý}¯_ÖnåÔ/nÌiŸq3™$}¨®Y‰Â€xWÛai¨E%Ðþ^Ïñ²ÄÖI»¶Û~¯ÄöÝ Ð°‰q^½(ŸžcªÚìõ­6×+º>SWs¿Óíó°bº¢½C¶´€ÇЕ‘äTÙ«xúS3ܸ‹RÙ¼"[sY6vÓ‰¡ cZÆLô¨SLÖ†1ÅsÉžÅHÒŠ1Ç„¤z´i£bÞ5Èâ¹æÏo N&¬H¾•Í&zô (IÆ+¶z˜xE»XÖŽ!ÇÎä{è®Å¡EÉØV|רëT”ÙnREà ÖR“Gm «SdqKÚšýEH­=ªG´u&®Ž\F4¬»I§#®@ëV«4Ì*e‘©£*}$ô­ãˆ“[•£çohBDiÕ?{ ×ÉñSË (¥ûÈëÖý·[í®›>ˆþƒðgļŸÑ­R£XJ­F´nìâî”ÚQ“n›|ë•s4¥Òœ¯åñGÒ¿?ÓTx!Î8¤ZFõ­¿LÒl´Ž†Öߦ"’:;K\㊠HémìíÂó@ìtvºYÀùi\«i;† qJã±§…Ævqô£Ry—roì"zF*,Ùw#oäñ4ìÅÏŒþ~ž_éE˜sÄĹðó¨,ÑàShç®ô 9ýÝ!Øå/t)WqÙL–ŽBûN+¸æ‹ÑÉ^ÙŸ—š£6ŽZæ…²9¦™”‘…qæ­3 DÇ•1š´sJ% Eh™Ë4Puæ´G H”¦\ÖÑghÜȸŒäpk¢±ââi'súŒÿ‚küT¸ø¡û(ø6ßQšê}gÁWxNæââ¡GK`j"ýäK9í#ÜÁ\¼nNï¾ßIƒ©í)/-Å8‹°™„ÒÚ^òùïø¦Ï½«¨ð€ ( €0|O⯠ø'C¾ñ?ŒüI¥è>²Ùö[Z¼ŠÎÚß{¬i¾YQw;¢Œ‘–`$Rm-YQŒ¦ùb®ÏÏO‹ßðU/Ù‡áÏö†›àûýS≠ûd †íŒVQÜÃ…e½Ÿb´2¹!g¶[…Ú¬àP>ÄÓ‡[ž¶#Åâ,Úå^åþv?>~"Áaþ7øƒíV¿ þø_Â6 oöNYµ«Û[–Þ>Ñ ¿¹„m Xä‚EÜ„¶õmƒšxçöQíáøZ;Õ›~š™ñW‹¿l¿ÚÓÇz¥¾±®þÐ>3¶»†Ým–?j ¡ÀP30-—“>\æFRäª,ñuSÝÃðîšþ~ºþgΚ”·úÞ©©kzÕýΡ­j]Þ_ßLÓOw<Œ]å–F%Ù‰ff$’I'šç•y=ÙëÒË)SVŒlˆRÍGðŠÍÕg\01] …šú —TÝ`—aÿc_J^Ð¥‚]„6JsòЪ°x¾‡¢x?â·ÅχZ]Ɖð÷⯌<1£Op×RØxw\»Óá’vUS+GŠ¥Ê¢)b3„QÐ Ö8™ÇE&qVÉ0µ_4éÅ¿4™ö?„?ਸ਼†5;‹ýgÅÚ‹m^…tßèVÑC–R%Sd-äÞ•¹L;eIÚW¦DõÔñ+ðv jÐN>þ·>Òø/ÿ€Òu ½#CøùðÛûK˜î|Uá)^âÚ9pžÂLË) ì“M!1ü±áS®–ai5cçñÜZ’rÃJþO¿kßÉ/3ôïá÷í9û>|RÑ/+¯-—Ÿù—Þ7ÿ‚¹þÔ'·×ôÿè^ ð…¥ÝÁk û+ oµ :(uC%Äo+”[¹¶îfUŒíÛÉÙ›,¶!ýœ§¥Ù‡öb=[á߯?ŒÿþÍÃ/Š^'ðåŒ7ë©ÿféš”ÑÙOr»ù­wy3dE°‘2¨Vx­!Œœ>rb8w ‰¿´¦›j×¶¿~çèw¿ø+gÇO ÛçüSðf…ãÛH`•Eý»b_Í3K¹^Y"G·(¨Z0‰n„á bCoì§™µ¤ÕÏ›Æp59»Ð“‡â¿ÏñgÚ_ ¿à­ÿ¼Ký‹eñÂÞ'ðN©sç}²ïÉM[M±Û¼Çûèqq&õT-¯Êò`üªd®ºy…)|Z_×Cçñ\Ž¡wI©¥òoäôüÈý,ð<ñLŸZðŒô/hÐNֲ߸Q‚þæ ¬ci"fPá]©9éî+¶2ŒÕâî|Åjpòå­Ù¦¿3«ª2 ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( Æ?Ž_ï~7øëí0¤ àÍYí´DŽ6 4LÊáÙÕ_t¾\m°€B®7fû¼£/XJw·ÿ/—â'ø‡Æâ c6½…&Ô-Õu“ºNò²ÓNUekݾsKÓ‚„xô0øö+{ížâº£¯Xë,í1ƒŽkhÄó+U7â€*Ž+CË™—:zÐ8¢Â'­Cfð¦ZXóÚ¡Èë"äPÚ²”ÎÚXvËémžÕ‹™èÓÂÜ»¦{Vn¡ßK~…µ´ö¬C¶?"O²ûRö†‹ ä)µÇj9Ááži?º_À_‡·ž asãïô}F¼‘‡Ûfʇr¨ âVÞü¨8TÞ"òs¬âNÕÑÍéú¿ò[½»]6Ð<3ðßâ{O”£†½Z¤R÷#­’oE)µË$Ö³å”a$~jZ–§â=oXñ·qökUº–úòãbÇçO+—vÚ (Ë18žøŽ+¨éü?¨_i÷šgˆ4+û­;\Ó®#¹¶¾±•àšÒâ6’E"ÈêÁYYNA‚®z’•)Úþ‡µ…¡K0Ãóòù5n½W§è}cðçöèý­~j¨iõýrÖiíæºÓ|epÚä)åfä¼£†esÄìùT+­|^ðůŒ¾xÇKñ†çÚ¿lÓ'y4i/“2}øf ,e¢,‰¸Px®ØÉI]3æªÑ©B\•#fw”Ì€>?ý¹¼?g¯ZXÉq§âˈ¼9ÐEЉ8w¸oûªÖ°ÜǹA`θÇÞ^ܾ—µ®—mO™âì{ÀeU%ç÷õI®ÿ™ø»á‹A¶!Ü×ÚщüÙÕÕžë¡À§éÓGÄcj7sÓ´è¾ïÙ|Ö"GycJéŠ<:Ò:ëu ŠÝly²Ü¸¢“*´‚³g\r1Y3¶š4`+žžðô®iÕ ¥+¥™«8æ¹æ{{#J2N•ƒ=Jnåø‰V2=NÆÌSp9®iDöéWÑ´»ÊŒÔ¨ØÖuyÚEËgÛšÎjç~§)yd'½bÑß— W{§Òˆ» «i$Oå|€b§›S£Ù{„BÔ±É^ÒÆ+äîÊ3éÛŽÚÖ5´8+åœÒnÆ-Þ–~Z꧈<,fS¾‡+y§í'å®úuÆåÜ­èr–d»akÒ§SCⱸ&äìŒ ›38®ÈT¹ó¸¬§©‘*}k¡3Ç©“&rJÑSVfý¨Á u©”M¨Ôg ¨Ûýî+šhö°õ#P¶ÈaŠçš=¬=Ko¬ZmÝÇ5ÇR'Ña*Üñ¯Ø PW‚ yõ£sì2Úî-=ÜÚ›kÉ¡#îµ~-ŃÌ'$­ûË}þÖýo­–ɯCý7ð'Š©ñ/aèN§5|/*j+øM(ëËìí&“”¡=ÚmÞ·\‘_8~ÐŽ†Õ8,´t¶QƒŠ G_goÓ‚ìu¶¼¯®QÞXÙ!EÊóJÁ{#£†Á|¿•0jÔNj•lmÚéÀG÷kUŠUõ4¢Ó …â©BæRÄØ³ý‰óä'$U{3®k¹š7_’¥Ó5Ž3ÌȾзÇ÷:P©•,]Öç=s €œÆ?*ÎTõ:éâÕŽ3TÐÀVÄ¥fÕŽ¨ÔçG–êº7/… »y©éÆ-Ù^hL†?Ô-°Xâ¨ÆHån¡Æ}*“1’9Ù×Öˆåš3d^¢´G,ÑBQZD⪊R æ´Lá©™³/Q[Åž]hÜýLÿ‚GüRƒÂ¼eð»PšÖOé+-£<¼Ó_Øy’¤Hëò"i¯Ý‹ŽL(v¿³–Ô´œSó^4Á9ÐŽ&?eëèÿàÛï?¢ÊöOÍ‚€ (‚ø‘ñGáß ]xÏâwŒt¿ øn ËöÍRqŸ"Æòù0§ßšb‘HVÃHûHU'ŠNJ*ìºt§V\°Wgâÿíÿ~’Oí_ þÌžÀýí¿ü'^(‡þ»GæÙXçþ½æŽ[ƒýä’Ú¹*bÔt‰ô8.KJ»·’ý_ù}çäGÅ_¾RÙF•›b1FR|eR=¼“õšÞÖKÝçÓîÿ#óøŸû-ú• /k]4öv…­/Nm“¶ÜÖi¤ÏÏ K¨ð+ïiBÇòF;ÌÙéš}–6ŒWdb|åzÇggiŒ WDbxõj1cšÓc‰·&\ @ãÂ%CgU:eØãÎ8¬œŽÚt®iCožÕŒ¦z”p×5!¶ö®yLõèáMHlóŽ+žUZ† æ”vXíXÊ©êÒÀ––Ï=«7TêŽã¾ÄGj^Ô¿¨>Æ'ˆõM'º¹â}zë캑g5ýíÏ–òy0D†Ij‚Í…V8PIÇšš˜ˆÒ„ªMÙ%wèp¹E|ÃK†5J’QŠÑ^Ri%wd®Þí¥Üþn>3|bñÇ¿ˆ7ž=ñ¥½’ˆVÏOÓm€e°³FvHŒ˜FÝ#³;–vÀEÚ‹øîušUÍ1µM:%Ù~¾oòZé'†œ‚à\¢9n¹6ùç7¼æÒNV»QVIF+d•Ü¥y> ý«À”ÖèS±µm@8¬$ÏRŒ†ÎÔ»(šÉ³º;½3I-·å¨lêŒOMÑ´RJNOµMÍcÖtŸm1ƒxüuÿ‚“ø—ûCâo¯ÿgíþÆÑ®uo¶ù¹ó¾×0‹ËÙ·åÙö îÜsæãn[ÝÉᤧýiÿ~Sâ>+Þ£‡¶É»ÿ‰ÛðåüO‘|3o##“Í}U~™T½ÏlÑaÉ^+ѦŒÆÌô­6/»]GÎb$wV1ýÞ+¦(ñ*Èéc(¡ÇÔ²£š–mZAY³²š. ¬ÙÙM0Œb°‘éÐFœG„‘ëRv-Æø=k9#¶”ìÍ(æÀÖ‰êR­bÒÎAëY¸pÄX½Þ;ÖR¦zq¶ê][ßzÉÒ;¡Žó-%ðk7H맘X¿ ¾Õ”¨³Ñ¥˜ÄÑŠù:V¤ÏJ–a_Šò"rk)Sg£KM»³N+¨X ãó®yS’=ZXºRÜ»â²q’;éÕ£"Ï—ýÜf¢í>ÎMŒë»dÁȵ9³ÍÆábÖ§)yegŽkѧU£ãñØJç)y¦„,Û+Ч^úÊÔimý£a°ãé^ˆø|Ç&Þ‡+uhã$)®úu>G‚”]ìbL¥r1]Iž$éëfdÎr#Šw!A­ŽSQ·È$+)£º„ìpÚ„8ÝÅsMÖgžêÖûƒW%D{øJ–<“]´Ü$®±>¯VÖ>{ñM—“yê¸ òšüÿpJ® bôßžÏGøÛîûÿ¯¾Œ\M,ÔÉæß&*É%nziÎ-·ªJÑi{¹+­ŽUªdŽ+òÃûÝ%²p*KGK`Ÿ0 ¤w:tv‚ÑÜéðgiÅAG}anQŠÑ+œõge¡ØYÙ†b·ŒO&µk=®›•QŠÝ@ó*b,Íëm$qòÖŠ LQ´º>åekìÎ7‹³Ü‰ôSýÏÒ§Ù–±¾e9´2ÊÃËý){3EŒ¿S›¿ÑJ‚<³ùVRßCŸS„Ô´~ygŸjåœwˆ‹ÐógFXƒœý+¬z*\û5®éÇ.vÐ[G”j–›²)£)#‚Ô#+ž*‘„ŽJåy5¢9fŒ¹GzÑ“Ft‚´GTTqZ#ŽhÏ‘kh³Î©SÁÞ-ÔþøÛÁÞ?Ñ µŸYðÆ­g¬ÙÃzŒðÉ5´É2,Ь¬P²@e8Îë]T&á5%ÐùüÓ E Ò–ÒM}úÚ…üK¢xÓÃ>ñ†¯~ÙáÍvÂßSÓîü·‹íÓÆ²Dû]ÈêpÀœõ1jI4~Rœ¨ÎTæ¬Ó³õFí2€?4¿jÏø)Â/Åžð ÿÂgñ£Oó¬¾Ão3G½_,búã+¿o˜ùŠÜ»oâ‘ o˜aR¼iéÔõ0YUl[Rµ£ßüç‹ã_ÇoŠÿ´WŒ/!økâÏ€<#ñ#Â^‡|Ccõ¾çä‡pù¡—ËgUš7 ˆítu' ×ÑÓš©8ìÏÅñxZ˜*óÃÕV”]Ÿù«ô{®èî*Îp € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( €9Ÿø·Fð…uÿkóyzN“l÷2ídW—åŽ=ìªdvÚˆ¤ÌÊ;Ö”iJ¼Õ8nÎ<ÃG,ÂÔÆb¡ÛÛ§Ev•ÛÑ+êÚGâf£â=sâŠ5Ÿx¡ }X•fŸìÑ£@¨©"òB¤hŠ2K¹bÄ’GÀáa†¥pÙÅœSžâ3¼u\f%®i>š$–‰/D’êû¶õ;}*×j'ëB'çøª·lîl-ùq]G‰^gYm5ºG›9]šJ;ÐÉŠ'EÏ5-…˱§Jɳ¾;š¶ð+žr=l5 ›p[gË9žþ }è,øW$êŸC‡ÀèmÚÙtâ¹*U=ì.ÈÖKÎêžÌ2ý6,GcíPê4òÿ"F²àRUM'VØüÕÿ‚–|Eÿ„Wá&‡ðÒÞËÌ»ñÕá2Ï${’K)!ö°pVS3Z•e)æçiÚkçøŸìpŠ‚ÞoðV}íò¹úÿ¼+ý¡ÄÍ$í,t]\ª)E]YÞ<¼÷Õ>n]ÕÏÄ»8v¨ã“_™Ô•ÙýÁ‚£Ë ·‡Ž•Ë&{Ô©Ù •±m  ÊLô)BÇ{¤é™+òóY6uÂ'«èº9}€'5'BG·xgÃ@˜ÙÖ„®’‰ëVýêœ}+¢Ðòq­+ž» è`?Jê¥Lð1ØÝõ=.×C ääWdiŸ7Wn§Sa¡ô%+xÒ<ÊøÓ¯¶Ò0˜ Ån©žML]ØK¢ÈJ0Ž6Å'Ò X¯ÍRéØÙbÜ´¹Ï_X æ²”B…{{ªh ±!x5É:g¿†ÆYZç ªi‘¢°ÛÍsÊ6=ŠÜÙåzÖš§~rÍþlòMkK\±+Ås=ìÆî'“ëV@oUZdII¬Y2³œUÉÜ?3qV™„‘â§™šû4‹Px&i¤ "øU-L&Ôv4‡„^Ù˜y_!ö©“±µ8©£:ëÃG÷|})séXæî¼:ÈNô§Ìfé\ÀºÒ| NÒ R‘”èœíÍ¡ @²‘çΉ™-°ÁU©œµ0é«3é?Ù‹öÁø¥û*jºŒ>KmkÀº¬ñÍ©x[UwÈêÈkgS˜.%1ù˜u#ixäòã ëa1³¡¶«±ùÿpÆ6øýÙ­¤¿'Ý_[hû5vOŸ >)xOã_ß |PðD×/áz–½€Á4.ŽÑK‰È±È„©e% Ve!ÒR©ÐSŽÌüO‚«—b'…®½èöÛº5¯~ög£V‡ P@P@P@P@P@P@P@P@P@P@P@P@PÄŸ·‹gÓ¼á¯Z<é/‰oÌ·b£’Ö×c´lÇæV3IjãhäFÀ8ow!ÃûZî£û+ñð.~SâÖnð9M<[N´µÑYÆmwO™Å«vw}Áº-Hã}}í8ØþKÆVæ“=3N¶À^+²ù¬EK•¾1Åoy5¦t €+Fr­Ye¥³hD·t¬›;iÀÔ‚,‘XNG«‡£vn[Â8®IÈú 5¡ÒYÛŽ+Š¤Ï¨Áa–‡Ion§W æ}F ™¿mj8â¹'Pú<.ñÛJæ”Ïjžv,}”cQퟪ+hFöÜt¦ªÏ ¡ü¿þÕGǯþ(ñŒÞg…mÒt—ntøY¶IÌq¿ï]åŸlƒzyû !~sœãþ»‰”×´^‹ü÷üí ¸QpÆKK 5j³÷êŠVÓv½Ô”n¹ºž%kùkÀœÖ°Ô’±Ð[D+ÏZœßI³S´‘Y6vÂ:§¢X+2|µ éŠ=“Ãö(  Ð‡4ít{¯‡`Œkx¤y•§$zžeNÁ]0G‹ˆ›=7DtR€ ÍvSgÍcS}OE³‘8ùGå]qgÏV‹:{yB… ʶLójE³z•ÙÚµR8gMÜ™f {S¹(]a³Q#zZ­ê›ŠÆG©Eœôy ‘\òG­FV<óW0Ä‘Šå¨ 6y>´!]ã©ö®–>«vyFº£ÊvÀÆ÷>‚ äÀS¿T&yV²€ïâšf2G—êáØTŒdŽjázñVŽi£eëZ#–hÌ•y5¢8ª"„ƒ­j™ÁU%ZÚ,óêÄΕzÖÑg—Z&l·‰åÖFdíoÊ®Œ™×­tAž>"'uà‹™.,îìr¶¬ ·³äãPN}ý«ÊÍ)¨N5Úý¾àLTñ8Z¸I­)4Óò•ݶèÓwmïn‡Y,8ɯ>2>Æ¥+“GÖ¶Œ2µ#æ¼WL$x˜š;y ñõ®Ús>g‡M=ÐÏVæÚÚûÄƣ⠓çßê7“¼òÝܱ̲¼–wg,Å›’I'“_«`)ºTa n’¹üÅØØc³ N"Š´')8§£I¶ÒvÓf} §ÌœWµHü¿-ëú0 (5èS>Kõ;û÷k¦'ƒ]mºd[£Í”µ5£à fdëÖ“5‰e fÑÕN¯PѼfH¯JƱ©bu–¥ÄÞ5¬H&÷©å5UÃΣ”^ØO´sÖŽ@Xž—ÜSG Þ%÷nX >DfñMuíoýê4RÆK¸¿loQKÙ!ýv]À^0ïG²¸–:H²š›Žõ‚:ášÉ.¨üš—AÇ6’4!ÖHÀÝXË zTsƺškš¹ç†=l>wæmÛêåö®þ>µË<5µ=ì6tçhÜë,/An¯:µ#ìrì}ÒÔßӢΠïÉ®Jò>‹,£Í«%¿±ÎN8©£ZÆÙŽšö8­Fà çojõ(ÕÔøLÏ/²nÇœ]éìîçn}+Û§Y$Ì1™l§)i¡Éj¡ ýzªs#ãó /²–›œµÔx®‹\òšvg!©[ä1Åc4zz–gškà7ÇQE„™åZÔ\5qTGÔàäx§Š Ìrv5çVGÙ哳GÚ|¸@Jàûqý+ðœò„¨f5á/æoÿ÷—àÏõwÂìÎŽoÁ¹V&Ši*0ƒ½¯ÍI{)lÞŽPmuµ®“Ñt61ŠòO¾GEc'"‚ÑÛXM¼ÐR;½.a•æ ´z>&BóZEœõâwzs}Ñ]0<xÛÅ£IÓõ+¼E§Zþ+m:ßìi7ÛÜy’(YŒ ¬UNa²‘‚Â+ÜËj%x?SòÎ4ÁÉû:ð[6Ÿ}vùhþoMÏÿ‚„þßgí)‘ð·àÝÞ¿eð¢Ââiu›«Å[TñDé(û1ŒÈ-£ùÈ%e.ó)xQàF®ŒF!mÈÊr™'í*ïÓÈüÁ·· Ž+͜϶Ãá”lkEJæ”b•üqÖMž:v-"Vm¦YTÅCgTabuJ†ÎˆÀR¡³¢0& RÙ²‰2§ ©¹²:¥Kv5ŒK &Í£ÄúÁÑl±¨\eaùwÆ71íÀ?™šëÀá¾³SÞøVÿ¢>wŠs¿ì\%¨¿ßTÒ]+[™¾š'¥ï«Z5sÊ­¡y¤•™årYŽKÜš÷§$•–Èü› Bu$êM·);¶õm½ÛgIijÉ× J—>§„²¹· ¿N+–S=úcV(z W<¤zô¨XÓ†ß88¬e#Ò£@è,ìóƒŠÉÈ龜Oi6ª¦I¨r:!Hîô? ³”fL“íQs£ÙÙÉ£x=fEG‹?‡Jw!Àìm~—`uÎ(µØs(+›ñ|8Æ1éV¢a*ƽ·Ãâ¤fÒ­#šu.U¿ðB¦ìÃúVsG] ½‘Áj^(IX±øV'¢µVgáÍŠÄÇÓÚ‹‡!æºÎŒFâšfrÏ9½ÓÊIÊö­ŽJ”ŽnîÛnx­9*@ç.mÁ$â·„ìyXœ:–§ëWü{ã¿ü#ž6ñ7ì÷­Ï/Å>f³¡üŸsQ†!öˆþXÉ>m¬A÷I"¢}‹j‚Òóïå8‹7IõÕzÿÃ~Gä^ eÔã˜SZÃÝ—ø[ÑïÑ»h®ù»#÷½ãò€ € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( ÇOÚ Åxãã‹®Yæ6:4¿Ø¶±O#D¶ä¬€mÎå7áÔ±-µÆq€£ï²L2£…‡yk÷íøXþGñ?:–ežâo–“öjé+ré-·N|Í7­šÛe‡¦B  ¾Šüo6îwÖ0¼WLO »Ôë,×å­ây•]Ù¤:Ód"Äu:©¢äb²‘ÝKsbØ+šgµ…Fõ¸ÁÉ3è°Ý¢ÈŠóêŸ[€IØê-Ux®Œú¼$QÑÚ¢œWFϧÂA3f8–¹e#Ü¥I„KíYó3±RGÊ¿·‰µþÊ5* inn4ÄÒYn•™D7×YJÀ+¼EråNp)!†Tðæ5<%F»[ïÓõ>§‚òêxÎ ÁÓì¥Í§x'5ò¼Uü»n1‰Â×çuý—ƒ§¢:;dé\’gÐP‰ÒYÅœV,ô CÑàÈŒb³g\ëZ4!@Ô›£Ô´†Þ—RžÇ¶èl!5ÑcÉÄ+ž‡§^€@8®ˆHò1OAÓ/åé]P’< Mvöšœj@'õ®ˆÍ-\4™ÓAªÂBóúÖêhóg…•Í(õX€ëV¦Žiad[Mb!Ü~u^Ñ<™Rã[LàRêÓÁ3Ÿ¼ÕÐç +T;èá8íGTá¾jçœÏc†8Nô¼mƒÉ®iÈ÷pÔlÏ3ÔÉbÅqÌúL6‡šø„nü÷®in{4þÇ5rNìSy¦¨™A›<ãQŒ5F29+•äñVŽy#u«G4Ñ•(­QÅQ$¢8j"Œƒ­kpU‰™(­âyu¢gL+x³Ê¬Œ¹GZè‹<ªÈË™zÖñg‘^'GàBx„Ù1“mÜ.Š«÷w¯Î ÀU‡ãîk—3‡>›ù_üÎÇ»ÀØŸ«æîƒnÕbÕ–×^òo^‰I'«×³g¬ÜY•ÏóêGì(Üĸ‡â¶Œ2½ŒKˆºñ]P‘âbiqÙ-Íõ¥«’iR2W® ŠôpqU«B›Ù´¾ö|_Õž]—bqtÒr§ É_kÆ-«í¦šê~‚x6Ål¸ï_°aÖˆÿ8ó‰ÚRgÐ:X(+Õ¤ÇJ÷=sG‹…⻩£å1r;»Áºbx•κÕ~Q[£Ë›Ô¾;P$J:Òf‘d Ô›&<5+¤R]v!˜ÑÊ/lÄó½Å¢öÌþôr UšíXïK‘«ÈrÝóÖ“‚.8‰ü¯F¨tÓ:©ã'F Q•ÝX΂hô°ù¤ã%©ÖØjî6áñø×[²Ë³y«Y­—ˆ {7¾Wë^e\"–ÈûœJ•¹å¡»/ˆ¢#;ÿZäŽ ö=ú¼MM«Ü¨5½Ï—åîÇ€+Ob©nÎ5˜ËðFë¿C öÝgI Ï9ÅuÒŸ#\ÇÏãðê¼$é î—6YŸŒúׯO‘ùÞ7(ªÛ”ŽBúÐGœ°?A]ô§Ì|Ž7¨õÔáõ8ñ»®g>ži¬EÃq\uôXIO¬Ä>l×D}VGŒxŠ Ë*Ÿz󪫟c—ÊÍ3Âß1ÝN¤’7äÛüó_Žq(ÓÌy¢µ”S~·kòHÿI~Ù…|o:5¥xÑ­8CE¤\aRÚoïNNîï[l’Z–òŽ9¯“gô7-' Eu…Òð3AHíl/•9¤Ñiž‡¥ê*BóN&U¶=MÔ—Œ‘]1g^7= KÔ£;sŠè„Až›¤j1ü¸ÅvS‘ó˜ª ôm?S‹hŽuÂgÏWÃHè!ÔáãšÕMÃHØ·Ô#aÐb´S9*aÚ1µ]I[¬ç;x\3“<»XÔãrÚâ©3éð˜f¬xï‰&GójàªÏ­ËàÒ>zñFßÞcÞ¹%#è¨R“>rñ#1ñÚ±ÜîååGjó¸b­Là/\š´rÌÆ”ŒÑs3äëZ#’eF­É2³Š´rMå¬N*ÈæµhƒÁ"žä1]¸yZIŸ-œÒS£$úÛóF}¼Æo9ÜópÔ,kÅ1\Ò‘ìѧcA±lô©À´‹Y¶vB¥\Vmp‰:­KgDbXU¨lèŒ ÕjNˆÄ™5-›F%…NÕ76P,¤u ›F§šÞÊÞ[»¹V+x†æ‘»õý»Ó„%VJWlŒN"ŽŒ±‰(Â*í¿ëVöIjÞ‹SÃoo¦Öõ¯ç]»ð0Å„j:ŸÌôä“_QN”pÔ•8ÿß…ã1Õ3Ìl±••¯¢WmE-’¿ÞöM¶ì®kZ@8®Z“=¬+ 8®9Èúl=xbéÅsJG³B‘»§Ù‹‡ÙÞ±”N•3¬¶ÐØíùMc)*Ga¦xjYÈ Ç­fävF[ðƒà“Q·‚êÑÉÆOcM+‘:œCë-á>e‚ãá­cG˜á¯˜:Kc×ôÿ‡~Ó­^âDÜÈ¥‚p+¡a¢•ÙãTÎq&¡bO‡‘é:–¯¨iúŒ+årñ°åŒn(Â(Nn2+ˆ'ˆÃaáV‹×f{Gü"þ÷J€ÿ´+Ðöº³Lsø3ñÛéz*Ãec°ÜMÉeåZäÄòÓV‰ôy·Æ7R¦Èñ‹«Ä˜º<ÁÓÞ¼ù;Ÿ_B.Ǭ̱$òzZÁ³ÑŠ<þøFiÐhxç‰oíás XyXà{U$a)#Ë5i”2§SÜÕ# ³Œ¾&´G-CpkTpU3`¾Ôt}FÃXÑõ ?W°ž;«Kû)š­fF’E"ÈêÀ2° ‚Šë£7šÜùìÇ ð•:ŠñjÍØ7À¿ˆŸð¶¾ |/ø“%Ö™=ÿˆ´;;ëïìgßm ëD¿i…>w+åÎ%Œ£1e(UŽàkì©OÚB2îæ¬vꘪ”5´dÒ¾ö¾æµ=Z´9€ ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( Å ³ð—†|Eâ­F)åÓôkBx­•ZGŽÚF ± p =Å]8:³ŒíÛï9±¸¨`pÕqU/ËN.NÛÚ)·mµÓ¹øUá»QCP¨ÕúØþÌjó6Ùë:ttWtò¸‰Å’à+¦'‹Yêu6£ [Dó§«.¯ZAÌu:©—bê+)Ô‹|p+šg·†v7 <­rÌ÷ðïc§²`1\Qõ˜ZÇKný pÍS†™ÑÚ8ãšâ¨¨ÁMi©¹Q\’G¿Fhº¬9¬¬wFIŸ–?ðV/hÐüøiá¯6øƒRñ@Ômm|·>m½µ¥Äs>ð6¯yn0H'ÌÈ+àçóQÃÆ/vï÷'þhýkÂL-JÙµjñ^äafüå(µçªŒ¾íz†¶©ŒWÄTgõ&‘ÒYŸƒ\Òg¹F'We#ŠÅÐG£èÑmT8¨gTQéÚBò´QéZ)¾IèiNÈõ]&ëy­S±ÁR:ÛkÍŽî+E+µ(ÝŽª5ožE|+}Ž=[€CÖÊg,'‘©½€Ö­U9§¿CB=|cýgëWíNy`<‰á Çü´ýhö¤ýCÈ©>¾yùÿZN©¬0F4úï_Ÿõ¬ÝS²#ëX)ù¬åRçe,/C–¾Õ€nâ±”ÏF–œV¡©«n焤™éÑ£$yî±x²#®ñ޵‹Üôବy†¨éór)ƒ<ïTuÃsA›gj8f8ª2‘Ë\§Þ«G<Žzäc5h癓(ëZ#’¢3äkDpÔE)GZÖ'TfÊ:Öñg—Y²Ž m̬ŒÉGZè‹<šÈʘpk¢'‘]m.Æ›©éú‰‹Íû,ñÏåîÛ¿kÆpqœuÅk({Zr…ít×Þyôq?QÅÒÅrßÙÊ2¶×åiÚúÚöìÏ®5-,¡lÒ¾6,þ•©‡¾¶(NWô­bÏ>¬.sW1ã5Óx˜ªc¼;j—^!Ò¡‘w/›¸p ¨ïd\u(˽þäÚüOÉüQÄUÀð¶:µgÊ£Ñé9ÆZ÷Œšî¯uf}ùàÛM‘Û9ÛšýwXÿ:sŠ·r±îú,@2W©M Œ–Œõ ;×u3å±m¥ WDO¥Î¢ÙQŠÖ'5©tôÚcÁŠNÃÃzÒ±¢»…+̨°s ¸Ó°¹„Üh°¹„'Ö™.CKzPKà ÿ*vÆy£Þj1§U¦l¯Rº+Ù²½JWEªR!:‚3Š\ȵE‘A9ù¨æE*2ý£?~“’)R‘"j(z8¥t>I.…¸ïÇ÷éèÉ÷‘µg«ÀßÍc:<Ç£…ÌΊcóþµÎðç³ ãMÍ[ Z32‰aÛ&±«‡|ºŽ_œAÕJ¦§|u¸¿³¤XöƒŽÜW‘õWíSgèo?§õFFUöTÜŠè«KSÉÀæîcjW»‹ 溨R±áæ˜þfÒ8‹ÿ˜1¯N’±ð˜÷Ívq:’d7¼ÑæaÝ:Ö#[5ÉQþWgëܯ>©õø‡Šø‰±æý3^uSì²õ{>]±­Ûÿ U÷õù_Õ‹­Fš~òMü›Vü™ý÷ô[À×¥–æXÙG÷S8EÝk(FNJ×¾ŠpÕ«;èÝ­Å>1Í|1ýUs^ÞäTؤÍû[½„sÅ&uvZ‡Oš‚“;=7SÛ€Z…¡55Gy§êÿwæ­9ŽGDô /Vå~j¸Ì寇¼OKÒõ »põ× ‡ˆÂ\ï¬5¯”aù®ˆÔ-ŽáŒ¬à·ò¢ÃsKDyÞ»âÐ#aæñõ¦‘”ª9qªµÄò\;dž™ì*¬bæs·÷~d¤çµRFR•ÌI¥ ÆjÒ1”ŒkƒÍi‚«2.9S[Àò±:Äþ‘ÿà–3ÿ„£öNÓ4/ìϲkúž‹çyÞgÛwÈ·þnÝ£ËÇÛü½¹oõ[³óm_­ËçÍA.ßðçóßPö9¤å‰'éöCôr»O™ ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( œ¿jÏ üñ4vúÙ5=qáÑí¿sæùâWÌñò¤.ëT¹ùŽ1Žmµée}¶. ×K_»oÆÇÄx‰™fðî&J\²¨”—¿7Ķv¼9µ'{–šA6ý+ôjhþ1ÆÊç¤Xíy®¸Ÿ;^ììlÜ`WDO"ªw:KY­bÎ ÆÎæ€8¦ÉL™-ÂV-£â²hí…K0ËŒV2‰éЭc^€1ÍsJµCcrÖìŒs\µ)žþ×S¢¶½éóWJGÒáqÞfå½öÒ>jä+ŸA†Ì9^æå½öì|ß­rΕ ˜su5Òó§Í\ΑíC¦çóõÿ$ø§«øÓö…“áíÄ~O‡üe ½¤[‘üû‹È!ºž|„ ¹G·‹agìû† °¯†â:Ò•eÒ?®¿äUx/–Ò¥”¼Â÷fþJ Å-ûó;齺#á+`8â¾Rlýû´:[„Z‹:›FVLë‰Þé_*Ž8©hÞ,ô:ïhšF©mž«†Ö‚®vÚv´é·÷”µTζ pfNhæböQf´ñR1'ëT¦Ì熄Ø|FHÉúÖŠ£8炇CI|@6ƒæ~µ^ј<¸«â]¿òÓõ£Ú±< Yf?†<ËúÕª­™K%Lj”sæPê1C '?=C›:c†Š3›Ä‰Î_Ÿ­O1§±Šèsš‰”Ê–ΈA÷ˆÚRq'Zƒ¥+íÆ«•l¶M!Üãµ @Ùjd¶pz•æíØlÓFmœuÔ™'&™›9Û™ÍVŒd`ÎÅ‹zUœÒ3däÕ£–¡Ÿ ÎkDqÔE)ª8j#:aÖ¶‰æVFl£­oˬŒ¹GZÞ'“YsµÑyÑ‘p¼+¦ ñq1ÐýÓ´«­CÂ>Öo™s}¦Û\Ë&лâVc€02Iè1_ˆŠ§ZpŽÉµøŸÒ™Ej˜Ì» ^³¼ç6û·ÛÓMûq¯Ø„%Up¥]Xmw âº!#ÈÄÒºf—‚—oˆàÂç*GÓ‘_]®øÇþù£ùßÇÈrðÝ7ÿO£ÿ¤T>èð¡&+vï_ªPÙÀy¢´¤oÑø(}ëÓ¦|V3fz†›Á_Zìó8“³µn•Ð"¢:;VâµGDi#‚*¯sJ,)qw{P;†ïj˜i|u4 ân½»ÃÖ„Ù Ê‹"¤’ŒFŠ%F¸Ûžjy.T’ëÞ¥ÈÖ4Ê2]{Ô¶me)/:üÕ.F±¤Q’ó¯5.Fñ¢R{ïöª\•³êtj\æ‹W:³¡ÎïÖ—9ULpלÖjQL³ˆJCÓUL瀿C¢¶ñGÈ?yZª×8¥—4ô6-|I– ¿õ¦ª'¹œ°’§¬^§qc¯™¢òÄŸ{޵2£;£zy•z1tæôgKc~60,9®Z´u=¼¿1\­\dîÍ’9÷ª‚±ž"rž«S 䜎+®™óø©;;œ¦¢B©&µ™ÁCVy~·.C×F}&±ãºéÈzàª}vâvùd=°kͬ}®Z¶>wÔ%dÔn#i Èþ•ùWQŒkÑ­Õ¦¾çuÿ¥3û÷èÁ™U©”æsK’œá4õ½êEÆIëk%J6Ñ;·vô³c¸õ5ñõ Í.¶÷ «š°Þôæ“E&lÚêù¸¤UΚÏWÁ=&vÙ~z º;?ÄŠ¥A`Ö…t)F-æâeùyúÖªmhB]êÃÄê2µFyõpQgOmâ¥ã÷Ÿ­m¬óªà"t6¾+^?yúÖ±ªÏ>®%[ßBÅ›x$úš™Ô7Ãà¶±ÉÞøFpEsʱëÑËîyæ½â$m‡…a)9­ 1¢ìxWˆuÌï³Ym.‡‡ëš‚ÎïƒÅ4g&y¶£2dóVŽy³•²MhŽY³6CÖ­“e'­Ë2»v«G<ˆ­R9¤VUÄæ«±“t8'Úºi³ÆÅħÇFŒÖ“ÑØá¡iÅIu4#ZųӧäjI 9µ«¶tÊ¥:åV¬”cÛmÙ$µm·¢IjÙÚé¾ Ö/Ñ%رFyÃçv;qÿׯ ÃðÆ.µF¢¾÷÷-?ò?!Î|uáìµÎž œëÍZÎÊ{_Þ—¾¬¯ÿ.õjÛ>c ƒá¶³1Är'Ô©Wtx>NJõtÿüå«ý$)Bœ•<¾Ó³³un“èÚPM«î“Wî·: O…’ƒ›«çuÇHSo?SŸå]‹ƒ°½g/Ãü™©ô’ÏRýÞ‚õUþäDZ—ÃFÜyº|Þjþ®Q†£¯>¸1œQ{ØZ—]¥þk}|—ùýo}&0“Jž}ƒq’Nó¢ÓMßEÉ6¹W.ïÚIÝh¬ýÞêÂïO­¯-Þת8Å|~3ˆÀÏÙâ âÿ?G³ùÒ;Äù7áþµ“bcZ {=c«Kš.Òù]¹’ºWWZ„i\MŸK—bޤÞ(І™r*nh‘⟮Äþ%KÚM–P"21ùw·ÎJŒ÷V@OwØWÒåTù0üïí?ÁiùÜüSñYÎ-Ú”Riíwï6µêœSz=;$aØÅ…^+J²8²úVHêìÓ¥yõYögGmJã›>“NÇCi#5Í&{T£¡Øé°¨’2Hõ5›gd"mÐV…šŸ˜¬™Û’=KCÖ'ÓÙÚ÷hÂNGåF¨n0–ç²iŸmE¶Ëûx™øùÓŠÚ5šVhó«eñœ¹¡+ê?íã* zn­ÈŽ^¡Õ}©ü\E.>µ›w:©ÓTûF£ñzIùP*•þ!SfnªEmïÅ[‡ÎC~ŽV']-ŽNëâeÐbQœLÕr™ºë¹ÈÝxÖîgiÉcïO”Í×FcøÂ~FOçO”ÍÖFö½%߈_z®S7UM~yæˆuQRK¢Ù$Óå3•R£Mך´Œ%P©,€óš´Žz“¹™3g5´QæW•ÏÛø#^§©ËeûEh²ê7O£ÚÜh—PX<Ìa‚iVùe‘#ÎÕwX V`2Â$;F>+mÆKÐü[ŽéÆ5èÉ-_6¿u¿7÷Ÿ¶õêŸP@P@P@P@P@P@P@P@P@P@P@P@þÝ﫯„¾aœè'Yss*Ë'ò[É C+1Cqµ‘Õ+V-O‡ù}¼Ÿ[~×Ë·õsò?_쪊|œîîêÜܯ•ZÜ͵ÍfšJÎé·|)¥> ×ÜÁŸÊبÞçyi.®˜³Ã«­´Ÿ §5¼YåU†§Ck88 Ö±gHBPÀkFÎd¬N’Å"–…•|RhÒ3±j9qY8”ëX¹Ææ³p;iâlÍXn€s\ò¥sØ¡QW¹~@ƒÖ±•ž… ÉÆ[›j]0ÕÍ*·K4ésV P©ua<=Ï_›8õ6WÈ5r¼1íÓή–§ó¹ûoËç~Ö¿åÎrÚgþšìëòÞ'.>¢ôü‘ýçà]ooÂ8JÝOý93ç+nÕò³?~ÛözÂG©Hèí¤Á³gdYÕiÓí#ž*M¢Î¾ H(u+\Ö¶ÔºÔ‡s£µÖŒ`e¨*æí¿ˆ:|ô˜×‡^ï¿­r-íé'OzhGâpP3õªFmjV>)äþó­+‡)$^*Ãæu÷§re ¢[Ÿü¿ë?Zm‘²øŸ9ýçëSs^C>OÿÓJ.>C ï_y‰ùþZE­ ‰5RrKP(Mªp~js™½Ô÷䦑-œô÷!ç&™ ˜SõæšFm˜3¾x«F2fd‡9ª0“3äëVŽj…æ´G$Êrµ¢8ª#>Q[Dók#6QÖ·‰æVFd£­oy5‘—0ä×DO"º2'ÑxØ„~žü ðѾýŸ< x#Ϙ/yÇ¥åÀþ•󹜱2~Ÿ’?fàŒL)d”"Þ¾÷þ—#Î|e¡Ëc,…„Î2kη)ö\ʬnÔ­v– ŠÚ óq%ðZcÄ1ŸD?úרpž¸É…þq?œ¾qåáªOþŸGÿMÕ>Þð’Ÿ&ý^†Çùù›?yžß¥ qé^•3â±Néž§œ*×dšÄjÙÖ[œ5º<ª‹S¡µ~•¬N*¨Ñ EQÎË à÷ªL–‰7bÔLät¤°…±Þșǭ!¢“è*×!{Œt¥r” ’\g½'#XÓ)ÉqïSsUŒ—'žj[62„—y©lÞ4Ê2\Z–Í£LΖàŽõ ¦P’èóÍC‘ÑFt×GÖ¥Èè…#2[Â3ÍC‘Ñ%oHþ*‡#xÑ3äÔŠ¥ÌèŽ2©ÕJônjyÍVãWÄ å¸úÑíl7€R4 ñ‚¦2à~5kcš¦RÞÇY¥øé” ‡†¶†$óq+{£Ó4ŸC3$rÊî‡=ë¦5£=âWËjÐ÷ nKã8aùRAŸRkµÑŽRkš[ xnõHµ;mwR†!$“\Ø,‰,ŒÑ$jÌFh•a‚ÀÑ)rÌÁ‹6n’÷””šòèô·]­åmw9ó —¥*2¥ôJVjQ´œ¹ZRnön¢›Q²‹•‹íDH‡žkyNç•GÊÏ:Õ®÷óƒ\³g¿…ƒG”kršá¨Ï¨ÁGcÃ|U0Eœ›I¯6»>ß+ƒmXù¯P¸ ¨\¸9Éôÿë×äügYÏN—EýîÏÿIGú ôiËiaòf=7ÏRªƒZZÔ⥴½Û©+êÕ’²ZÞ·ÚH¯Ž±ý!rd»sJÃæ.ÇzGñPW1¥ ÷½"”‹ðêe;ø¢Ãæ:;=keéXµ#v-siR$ýiÌuÚ‰&J¤e-N²ÛÅXOõ”îbãwsjÛÅÝ?{úÕÆFi\ݶñ‡#÷¿­h¦r¼5Æ]øÃ¯ïZ‰Næô0ög=qâÂÀþ÷õ¬¹êF<‹C”Õ|Iû¯õŸ­;“Êy&³­yìá_ëŠ, Ùy¨^pÜóT‘”¤qWwØóV‘Ë9>sVŽi2ŒÚ´H圊¬sVsI“Ö¨ÂLª‘„ˆ$ïWž¡—uÒ·¦y8µ¡JÕq ?îåZÔ~ó8pqµ(z/ÈÛ³³žé‚CnqŸJèÁåÕ±ò÷»}_oóÿ†½‰8Ç-áZ-â¥z­^0[Ë[jìÔUú¾‰ò©5cÛüà1qê:Œ{¦~cB>èõú×Þey5, y’¼žïúÛþ÷?“¸÷ĬÊ+:2Ÿ-¶ã²ÒÚ»'&—WÕË•E;ñ¥èÐAÇÛÒ¾†ÒW?Åc%9Zæ¿ÙÆ6ª¾Â´±Éí5» BÍÖ†¬ NnÈå5Kñ³„åcÕÂÐæv<ÇWñNŽêaÔÕYU²§˜3ëŒy5çb}…xòWŠ’ìÒkñ>Ï%Y¶SUâ2šó£6¬å Êi´ìÜZvºNÛ]'Ðâôë#â äM"ÆHlúfBY›ßã¿sž:WÎ>Àb*©S‹ŒWKèýowå£ûÙãã§äø”qu©Õ«+ÚnšR…Õ•¹y íñ.h=[O™Y/qÓ~ Ý_AÑÝ:HFJ:ÿZô*p>“…áè÷ûïø„úRñVS9Çéâµ¹à—-¯·³t÷¾¼×ÙZÚßJo‚:½´m.]ñÑ—~XÍaSÃü7#å©;ôÙ¯ºÊÿzõ=lÒû:uáíð˜w ®d•HÉ«ê”I(¶¶n2IëÊö?>üs§k:|C§x‚«Á/—Í ŒGµ¸ÊìdÆ@ `:¦XöYï?àü÷üÏÔ0|QC‹áw Û…vä¹·ZµÊïü–åÓM4ÒÅ{;‘…é^}Ha‚Å+#¡¶»Á×éÜúl.3–ÚµÖ@æ¸çNÇÒá±JHÛ·¼ ‚MsJ³K­«7#ÕNŠÏ”ëUô4ôÿMdûL¤ÇõéOÙÜ®YÚçkgãÀ1ûïÖfRÆr|AÛúþ¾ô½™O¡ÎÝüF+)Ÿæýj½™ƒÇyœ¼Þ.’åÎéNßLÓödýrýLûŸ÷dçÚš¦L±–êdͯ¼™Á"Ÿ³3xÏ2ÔØä–æf/®.ä ~íѪ½™›Å܈Ý9êÔr ë-‡Ú©£_Xpiòƒ®0ÜQG)>ßÌŒÌOz|¦n½ÈZn¢­DÂUÈìí5-gQÓômO¹Ô5Bxím,,¢i¦ºšF ‘Ç‚ÎìÄ(P $€+ztÜ‘åc1‘£ NNÉu?©_ØwöSÓf…Ëý¡ö©>(x¶ KßÉq*²Z̈Æ;(–7hö@f™LŠÌdvwÝ´Æ‘ý>°ð·W¹ø^œK7Ĺ/‚7Qôîúëe§M·»j×QáP@P@P@P@P@P@P@P@P@P@P@PæŸüÂjÿ9+¬ úsb¥}é9ü¿Sñ¿ðø_ûÿl>@Ó®tlðpkìàÏæ|E=;[k®AŠèRjÕHâiÃt™ëUs A£@N§S2³& ,Zl‘g÷¨hÚ2e”¸#½KŠfÑ­$YK£ëPé0Å´[KÒ1†¬Ý#²ž9­™~=@Žõ”¨ž…,É®¥øõ!«@ôiæm+Üü ý®õ+göžø«{§^ÁužÎ–ÞE‘VX¬m¢‘ É":0êH8 Šü[‹¥í:¼®ëEóQIýÏGæ§GŠu—åî¼dý¤¬ÓO–Ug(½zJ-J/fškFxe¸Æ+ädDPÐݵ=+z”ͤ8Á™Ô«+€0 楣X³Y.qüT‹¹z ò„|Ô˜Ð]M‡ñR°ù‹QêΧ†ýh°ù‹ƒ\ dE‚ㆰ竚V12ël¨WÌàÑfý°?¿E‚áý°Gü´4X9…“\wÀ2Šv`šEvÕ ç&‹1Uõcœgš,.b¬Ú«/SE„äP“V?ß§asŸSvÈ͹“]±þ*v%ÈÍ’éÇ~)؇#>[‚Ù¦C‘BI:óÍRV3r)HÃðªHÆL¥#g5h曹MºU£šeI;Öˆã¨P—½kϪgÊ:ÖÑ<ÊÈ˘WDO&²2¦ÑÈ®Œ™Çº"xØ„~°~ºZÞ|ñTŒ±â›¥Éôégþ5åf±niù~¬ûî«xyů¶ÿ(–~-ha$p=…x-Xýfö›l|q¯ÙyÙOCÚ´ƒ9+Ä¯àØ‡öárq„Çþ±Ìîq¬¥Òƒ‚G¬x_YitñpïóM’?Ýè?¯ç^… Þ7>C5¨Öä]?3f]W üÕ«™Á)ÊêWžfvšÂr¹éáèòîp:šÈá²x®YÝžîÅãUe·‘È8\†ìŸò+ÍÄì}¶LÓšGËrLDC$ƒØæ¿Ì«ÏŒ«Vi¦ÛÑ«4–‰5Ý-þ°pNUC"áÜ (Ê0§zr„¥%Í)ÆOxÎMÊ/Ef¬’²çשæ>‹1"ÝÖ‹1j+Ü+¦Y¾ô¬W9f-D¡ûÜR±Jf’jüž‹Î]‡[uÆ$?!©›Px•‚`ÉúÐR’.GâwSÄŸ­tiÁâæR3'ëKQû¢MâÃ!9ãëE˜ù’Ø£'Š?é§ëEƒœÃÔ|Fó.ÕsŽôÒ%ÌåfÔŽIÝUc3 òóÌ“T‘Œ¤aÈùÍZG<¤Q‘úÕ¤sÎE65h月Õ#žLŒž)™6Dݪ̙÷ªG<ÌË‘ÁÏJÞ•ŠÙ’h¶m}5­ºŒ‚o ¯K„úæ)S{nýùíó>'ЏpÖEü-‚Æ([ìêWÑapJ+cñ¬û‰ç^MsSxoÀèUˆ^Í,9ù®?9m»3®¹ð\{vª&s[ºòašÉ;»Ÿ—_ðP?.Žß uû]' !½³ºÔ¢ƒŒþåáŠIëÿ ªOiz¾ Œ°üžÆªó&íédßßo™ýiôkÎ^)fX*•vöSŒ¿Æ§(ÆÿõíI¥ü‰ô?9!•‘¸5ð“Šgõ} ÒƒÐÞ·¼aŒœ×$é#èpØÙ-ÍûmChÈçÚ¹'FçÑasErðÕõâ±xsÐY³‘:ê2Æî*tG3›V¹ ¾ÇñRö&‹0·QãP#M/bZÌšê=µ)mÞØúÒTR*YŒ¥±Ú?fO×.ŸÖ—³E¬\…óœÿˆ=¼ŸQ|ÃÜšVE*¬pÑaÆ£cÄ”š4U»Éã4¬£bïÇz,W=†™1ÞŸ). Ï6Ÿ)>ÕˆÒñÅ $Ê®…i&ã­NJ•º­ßðJOÙËMñçŒ|GñóÆZ=­ÿ‡¼:iú7h²¡Öp“=ÈL«ÛDÑó#e-t®Œ c.çûÉ-¶?8ã,ÞPKJVrÖ^¾}|•¶gô^ÁùÀP@P@P@P@P@P@P@P@P@P@P@P@ñgí×áqª|³ñdVö?ið¾«Ì·7 ûå¶›6Ï,ŸšYm™”•R"ÉÉUÖÉk{,O+ûKþùŸžx™—<‚þO6×_»—Ä6WU|Ø.¥w#hf#d¾l_6 y[¶€Â¿âüºx,Ê¢žªmÉ?)6û½×¯mOõèéÆXn(ନ.YᢨN:»J”cÝÆ)óC’z]GŸ—™¸³É “§¡¯’?¥(Îæ¼2tÁ¬Z=:r¹­Çš†Ž¨È¶“à‚ I¢‘}.ÉžiXµ"ÊÝzšV‘"Ý`ýãŠ,>bÚÞº‹˜›í§®êCæ^ŸZ˜>ÜOñPÂ}»ý¡L\Áöïö¨°soŽ3ºóCƒó,O1¾Ëg4X9ˆå½šv‘˜÷Dn¢Ä¹ ûW½; ˜‚Kž¼Ó±.e). Ï4Ò3s*4ÄÓ±d '©ü)ØÍȮRFR‘Y›5F2ewj´ŽyȪæ´GÙJJÒ'B„µ¬O>±›0®ˆžMdeMÞº"yŒ™û×D¹úÿì×õY¼+ñ‹ÃRÏæh¶z}õ½·–¿»žt%}Àn;–Ö‚H8–Ï&ah³è8>¬ÕJ°ODÓù»ßòG·üN¶ÞXöàõ"¾n²³?mˤçOSã¯éŒd&EÏ­(º<»I c¯B«(*ù^??é_cÂUÜ1r§{)-»´ôü.8}!r¸â¸~Ž64ܧJ¢WW÷a8µ+ÛDœ”ß[$õ×ì NLP¶~V¿X ô?Ï|ÚóG·éw•FzW¥sâñTìîwÚlØÇ5Õx8ˆ\=5º‘åΙ« ÙÇ5iœ³…ŸhÕÜçp,¥È§s7ÆàzÑpän=M@3Œu¢à¢WiÏ­+– @fõ?™¥rÔ^_zMšF%G›ÐÔÜÕ@¬Òg<Ò4Q)É/½KfщIä©lÚ1)É'^j[6ŒLéd¨lÞ13¥“Ò¥³¢13e~¼Ô6tÂ&\ÏÖ¡PF5Óžk6κhÇ™Ï<Ölì‚0®_¯5”™ÝIÕÛ¾Mc#Ñ¥cîYN5”™ßJ œV¥pä0lƒê+žlöpÔ×C‡¸¼¸F|HÌäÑíS£–…x½Òèi²ÊÊÌù=|S¥ˆ×•‘ÊS‡¶Šè}…áyÑEn’ ¡vªa^ý ×V?"ͲÎI9´z7›+ `O<×]Û>{–)Ø©#ÊzŒÒmšÅD˸FpA TÚG™ø›K.% ™VGQ\U¡sé2ÜW+VgÈž3Ñ$Ñu•}’rJŸîŸJü›‹rŸªWXº Þ»i/ø:·çvÞ§úôyñ\A–K‡qŽõ°±¼äÜ©^Öwº^͸Åj½×Æ6ƒoŒóO½|uèþq †‹0 Où4ì.qDÌ(°ùÇ ‚:šV¨H·>ô¬R¨Mö¬w¢Ås’­áõ¥aª…•½ã­)LxÔþ#K”~аš—ûTrTõ"?ŠŽPu í¨“ÜÑÊO´+Ë}ÇZi ÔFt—ŒÙùª”L%T¨óžj’2•B£ÍïT‘„ªšAÜóV‘„ªÙêÒ9åPŒ½;9‘–§c7!¥½é’äBæ­#žl̺?#}+z{ž^/ág¨|6ÐLÐE{"ó.ý}îC‚öT½¬·ž¿.Ÿçó?’‡†R’G† .5½e!bH/ȯ6î¤ì}³Œ0Xg%Øû¿á/ƒÐ[Ÿ+¦;WÓ`0÷Hü;ŠóŽIËSí ø\(‰D`ŽÕï '䘬Të6ÏcÓ´¸áE'¹«•NTsÑÂ{iwòÌa€á;­L±8ofïósþ 5l!ø5á†ô4[ü”¼¯–ã%l ?Æ¿ô™¾}gÍÅx•ÿPÓÿÓ´OÆ5‘ŠüÍŸÜ0M½ Hà×<™êуµËñ3®+)$ÏF”§âÈOcY4wF£e¸ÛŽI¬äŽÊRîYQž†³:⯱ Ri\ÑE²uZ†ÎˆÀ˜!©lÚ4Ù Nø©lÖ0$ JæªMMÍXà¥)E‹ƒEÇÊÄçµ»C  m‰œÓ±-,i؇"“êÒ9çRÆ÷‚üâ߉>-м àMëZñv³8¶±ÓlÀ/3à’I$*"ª³»±ˆ¬ÌUT‘µ:r©%­O/§…¥*Õ¥h£úýýžþ i¿³ïÁÏü!Òµ»­^ÛÃðJS¼b{©¦žK‰œ"ä"f“beЦÕ,ä?IJš¥Ðü[‹–?'ýŸüt|ãû‹¿šÒ-BÒöÆãÌ‚æ,¡Ô°VIˆCª¶c'J±úì.>xóGOSù×=á,fWWÙUJN×÷uM?’}ëô¿?eâe*<¸'£gƒ]ñ­®§ÉVË[Ò:[_€à<ŸŽkhÖ<Ú™v—Hê­õáÆ$}kuTòê`|Ž’Ï]GLoæ¶Sέiìn[ëeqóä}kEPâ©‚¿C ƒY ªCÖª¡Á<žÆŒZ°Ïß«Uya:熼/ñ7L†?ÃÒµŽ¤Ëk,–· ‚&iK+ØUŒæé›å‰ø?˾±„†6šÖžkÙí¯“Ñ-~&ôÔþ»ú"ñšÉ¸‡Ã8©>LZ槬œUJjNIE&“=e6ã¥Åó7¿5-ß_‹M鮦ˆ×‚N•„‘ëÑ™¤²Ž+;Šdë/½"Ô‰ÄØèqJÅ©-ǽ+¤J. 0¿h õ4X9‰~ÕÇZV0Ót}haVèúÑ`æÝZv!†é½h°¹…û_h°s5É'ïQbyÆ}¤úÓ°¹Ä{ž:Ña9•Œþÿ•;æ7ϧbyÈÞz,K™\ÈM2†=騇2“Òˆs!.}j¬dæDÍM#)H®Ç©«H眈Õ£žL­%Z9*2„µ´O>«3¥´O2²2æk¢'‘]ô5ÑÆÄl~ŽÁ;ïZÎh§OìÓí¿ã\yœ¹cŸè}7PUjâéÉÿ·NüM˜Ìò±<ï_7UÝŸµ`aÉ xºfûD©œsšQ*²º<¤?“©ZKŸ» ÿ ÷ò±¥˜R”Ÿ[|Úi~,ü—Ŭ lf¨FòQRÝ/vŒäõ¶Ñ‹vÝÚÊîÈúïÁ3ïµ¶ô¯ÚpÏD˜ùÌ-RG¶iŽP¯¥zPgÅâcÌDÓ¦Cšêƒ> Ξ9:kdÏ6Q4à¸è æ­3–¥2úÜæ®æ™2ÜûÓ¹.˜ñqïEÉöc¼ð{Ñqr 3ûÑqò 3Ñr”šcëJå(´¤Òlµ»Hjnh¢WyO4J’9õ©¹¬bTw<óI³hħ#“RkgÊçÖ¡›Å$z“¢(Í™úÔ6tESÉÖ¡³ª2'“­fÙט×y¬Û;)£ åÏ<ÖMÔÑÏÜ¿_ZÊL年~íά¤z¢r—Ê6Ea#Ô ìp×öÛ‹l#ñ®iDöèTµ®q7–r[\E{æXŽì§_¦+šQq|Èö¨ÖU éËf}Iðt\êJã>V1žþõíå÷Ÿ¼ÏÌ8»’„½Œ7ê}S~ê?¥{ih~_9{ÌW€7J, v 6$óƒK”¿lsÚΖ$²™â±© ž†â÷<Æž‹Qµ¸·’<Æã‚:¡ìkÇÇ`©â©JXÞ,ý'…x›c¨æ8 ®jnñkñ]šjé§tÓi¦›GÊÞ…¨èWÔdÂË2•¿Â¿ Ír FVÜŸ½OOyy÷]?-µ»±þŒp‹™/Â4`ýŽ-ó~êN÷K[ÆvJZkk)+IòòÇ™áG­x–?Röƒ|ÑE…íóG­q<ÑEƒœQ/½h/ž}h°ý ¢z,?jH.}ér”«Ú}èåµ]c½£ö¿J9Dë ûIõ§ÊO¶"k‚zš|¤J±œzÓå2uHžq޵J&r®’+4ÙïV¢sJ½ÈŒ¼g5J&RªBe÷ªå0u†ùœu£”Ÿh7ÌÍ>R]@ßÅ22s“Tdår•Àù½i ÎJ÷YôÇÃ{T&ŠqÜ!>ç×ê¹b_V¤ÿº¿#øާ(çXè¿ùûSÿJgÑ6pn‚6¶+ÜŠÐü²µKI›vÑa‡¤QÅRE}]VÞÆiTV5Â77fyž¦>Òiă¡®9ê}û;_cÉüC;C «7Ë€rOLW We©õx)É8˜¿ ´5MPÞÉV~3ÏzÏKžW:ø›-g~‡ê·Â ˆ,cc$_kƒ¥Ë ŸÌ\I˜{lG-Ϩ4½1cEUz×Dæ  ‡–"ZìwV:r¢Ààf¼Úµ®ì}¦-Œ#ÍØç/(o\×u'sæ1ðQO¹ùCÿ3ðÍõφ>x½%€iºn¡y¦Í3 Z[˜ã’2£*Î]ÄrË€rHù>5£)Q£Ym×ÎI5ÿ¤¿Àþ€ú1f4¨fYžY$ùêÂDôµ©ÊQ•õ½Û«Y5e+µeÈÈ”f¿:“?³©E\Õ…zW<™ëСX·cÒ§M2üPYJg¡F‚EÔ€V.g}:â0;Ts\éT’èYŽö¨r±ÕJ…Ë"ßÚ¡Ìꎓʶis2ýŠD«#¥K‘¼hÜ•Š\×/ؤ4/4\žMGìã¥+—ìȘ¤Ìf†ì§r9˜Tµ2šH„ŸJ¤`Ù^GÀ8«Hæ©;#sÁ^ ñoÄŸè>ðƒu­x»Zœ[Yi¶€o™ðI$’T3»±ˆ¬ÌUT‘½:r¨Ôbµ<¬f6žœªÕ•¢ºŸÔoìcûøOöUð›Ýݽ®µñƒZS[ñ*!Ù d7Øì·Él¬– <ΡܱE¿‡ÃÆ„|ÏÉsŒâ®kVïH-—êüÿ/½¿¶k ñ€ ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € à|ð¯á¿Å=8i|£x‚Ù!ž_S´Ie´Y”,†Þly9 ¿o8ºÒu ýU·¸²ÔôùÞÚòÆò6†{I‘Š8ŽTI#—9î uG}¾HâÚhì¬òHV^Ê[ešxëo#)òæHËFû]y2 æÇQ†; S =¦šÚöìíäõõ=¾Ìñ+àó¬=ù°õ#;FNI?zÊöSá-qm4ÕÑøš‰=¬÷wKoyníÐN†7ŠE$2²žUykù×Ftfá5f´iôgû3“æ8|ÃO†¨§NiJ2‹MI5tÓZ4Ö©š1Hñ\’GÑQ¨‘}dµ“Gj™:ÉI£XÌ™d÷©±¢‘ ’•‹æJEaÞo½æ3Þ€æ7ÜÐÁæûš˜C'Ö€rd4ì.a¾aõX\ÃKûÑa9 2S±<Ã<Ïzv%Ìi“Þ‹æFd´ìC˜Ã'¥;æFd>´ìC˜ÂþôìC˜ÂôìC™zv3s#/T‘“¨DÍM+JW!fïV‘„¤WvëV‘Í9ä95¢8ª;”%èkhžuc2nõ¼O&¹qÐ×L±öïìO­6‘Åb²m2ÿf~8û_ø×™œK•Sùþ‡ÜxoCÛOï·³ÿÛÏ£|_ⓨ¬‘3åÿ½^Ï×iStÕ®|ã¯,,d%Æj¢eU³É5H®Á܃`}k»UPÄS«-£$þçsäø›S6Êq˜ -)Õ¥R ½¯(¸«Ù7k½lŸ¡ô‡€µ¤{hÇ×îXZšå†{‚jmŸCé×{‘ž½ëÕ„Ïñ¬Ú;M:÷ &ºa#ÆÄP; k’W†â·‹<Š”ì͸Çz»˜:eøî²9<úÕ&a*V,-ǽ;™ºdë?½;àʬ¶Ž§ÙŸô±e§ÙÛF¼+èpåŠHüˆq^Ú´§#è k_ÜÆ1ž:ר–‡ÁT©ï2âY“ü5\¦.±e,òGùLÝtgjxe#â¦P:(b,Ï/Ö´o¿ò×JgÓ`ñ›âïÛêv—V²F˜¤Ç*{ø×ÀÓÆQ ‹I+Áõ[¯3ônâœ_fX|Ï+T¥%%«³¶ñvi¸É^2WW‹k©ñž§gq¥ß\XÜ©Yab¼Œnë_‹ã°50åB¢ÛgÝt?ÃmÏô×…x§ŹM×$ÔÒæŠwä—4‰Þ-ïeui/u¦Pó=k’ÇÐû@ó(°{Q<ÃE‰öæŸZ9AU4úÓåTO;ýª9Eí€Ê}hå¬'ž}hå'Û‰çŸZ9EíÆ™ÿȧÈKÄ 7†Ÿ!X#iýé¨,A¸µ\†2Ä®äMrz¥b‘ ¹÷ªä1x’&¸µJRÄ®ã|ñOÏë<ð{ÑÊ?n‡ E.R•d<8jM)Ü‘jMc¨ÉÓåéUeˆ§¡ôŸÂ™…ׇ¬s2É,,ñ8R3íRC´¯^Äõú†ASÛ`©¶îÖŸsÓð±ü!âÞ eüQŒ„ ã55¾¼ÑNM_tæå¶‰Ý-¬}/¥¨ku•ô´ö?Å;LÑ'oÝ­t®dêo¾zŠÎnèêÃG–gšÝ1FvÏ~•Æô>’’ºGŒüD˜¥°ve`€Ìþ€×Ÿ‹zaÃð¼ý5={དྷÅödeçß—FÖ>OŒ«9s4ÏÔ/‡Ë°· Ï&¾ÂðÏç Í·‹×¹ì°4k£CXM6z¸yB;+ézbB7œŒf¹Ý.g±íCèÆÜÇ9us¹›šì§ #æ1x®i3â¯Û¦ÖÆ÷ökñì÷vpOqe6Ÿ=¬“F®ÖÒ›Ø#/#*Æ9$LŒ®Ã¡"¼Ž(§•UrZ®V¼Ÿ2Z|›^ŒýÀŒehqþ)µª±’M¥%ìg+KºæŒeg¥âžé‚0g¡¯Èf¢¸{ÜØ‡šæ‘îPÔÔ…9Ï&z´iêkE@ÍsÉžÍwFŒPô¬%#Ó£FåÕ·¨¬œìwÇ ¥¹i  ¨s:áA.…‘o‘Ò£˜èT.ך9İړ p:Tóª6Ðf…!JÆ‹p)ó\…FÄn fšdJ6+°ÅZ9䈊´sÉ•_“ŽÕ¤NJŒ®çhªG<ÝŒéääó…ÖðG—ˆ©ßdMß°ìAÿ Ï£]|CñôþÆŸX}’êÒÚ}öÚ “:Jm©Û4Å≥—•Dv†’o{ †ö+š_?'ϳ¯í9û*_Ëӻ}ü¼—ßÙ~×YóÁ@P@P@P@P@P@P@P@P@P@P@P@P@P@RÔ´Ý;YÓµ XÓí¯´‹èÚêÆò%š˜]J¼r#¬Œ¤‚¤A еB”TÓŒ•Ó>DÖÿ`_Ù_Wo]Z|8“FÕ5_=î‹«^Û‹9eÝûÈ-̦Ý6ÊFb1.Ù´m®˜bëCi6#‡rÜR~Ғ׳jÞšéùx×þ •ñ#LÔÒ…_´mGI–yØÛx®¬e³‡pòSÍ&YÛi`í²•/Í…ï§š¸üHù,oB£ýÄÕ÷º·mUï÷#åoüý¤¾i±ë5øO­ZiÂî&»ÓŒ:œV‘BI$ïjò¬(çt…AˆÎÖǧG2§SE-O‡Ìx+ƒ\Ò¤ÜuÕj’[Þ×·ÎÇœi~/¨x'Ó85èB½úŸ‰ÊyùNÂÏÄ H%ÿZèSÈ­€k¡ÔÛëY•¸õº¨yu0VÜׇ\njÑU9'‚F´Z°q÷°Õjw9e…å4#ÔúdóV¦sË [ì܇⫝̸ÉзBT¾#©£œ—@ø£ö®ðqIôŸ‰Ze¾Pí°ÕDIÓþxÌÛSë;·üñP+à8Ó*UTqÔÖ»KôoO“mÿ*?®¾ŒÜ}<êð¦2~îµ(Ýíÿ? ¯/J‘„cÿ?fÙòL7Hàmnµùœ©µ¹ýÅC ¥fhÇ/nÕŒ¢zT«ÖJÍ£®3&zÒ±²™'š=iX¿h8=+ Lxz æAæ{Ñ`ç½Ìýè°sˆd&‹ œiz,O8Ó&;Ó°¹Æ:Ñb\†—4ÉrX÷4ìK˜ÂôìK˜ÝôX‡1¥ý騗22ôìfæ0¿½UŒÝA†Jv!Ô#/NÆN¡zv!ÌŒ½UŒBr{ñT‘„ê\…›Š´Œ%"³¦­#šr)ÈzÖ±GYs“[Äò«;™ÍtÀñ1.ÇØ¦°Ð>Ãsh¸Ô5i¥šæV ¸ìvÚäN ¹q_=›T”ñhÚß5ëä~ÅáöŽ'Ž& ߪääôû2qKkÙ%tìÛ}NÒûYf.KòḵöîG›ë“HXäÖ‘G-Yèp·D¶Ië[Dó«lwß µ“ûér·Þ£9ô?ýqþE~‘™—µ§õI¿z;zÀ½ºiku?Š~òügöþ)Q¬í;YZ¥ôIi4¹›÷›Ÿ;“Wþ®Ò5fX㉎TWÞÓ©ecù+„NNHô :÷v´îM‰i¡4Þ€# 敊ºE!¢\ÐZer¾µ64L¥/©fÑ(JpjY¼Lé\j:!2iG<Ô6tÂ&%ÅÆ æ³lí§LÅžç¬Û;)Ó1.®Æ8¬¥#¶•œ¹¾<ÖNG£N…ÎvëQëó ÆS= Xs•¾ÕU3óŠÆS±êP¶rºäc9jç•CÖ£‚g>—×ú½È±Òl庻#>]º—*¹scî®HËžMd§*– ìô XX{\D”cÝéçeÝé²ÔÙ·øwâkÕŽKéE°$3Cï`¼dnÎud}jÖ¤µ–‡%LÿEµIsy½ý7·Üý<)á Ý3Å—6—î³Mo€®¬ÊÜä¨û§pyç¸ ž,· Œ§ˆ«õ©'ªå²²µ·Ý»»êžÍhÚhúŽ4Ï8w”`¿°(Î ÂN«œœ¤æä×&уPµã8$¥.eÆI}Íá 0áyÀ¾Ç#ù³6¯Ï&{]ŽžZ$f½(ÇCã+×´™·˜ÉZÑ@âž$‘¬øÀr’«—–9_»Q(4«YœF©¦‡ òó\ó…Ïk ‰³<¯ZÒß”®*”ϨÁböÔøûã'„|°uÛXñ$\JûËê~Ÿã_Å™JÄQúÔ½÷®¿vë禧õwÑûÄ dùŠÈ±.ô1-%w/v¦Ñ²W^û´%¢û-É(4þrß_šØþÜs\Ó±. Ã!õ§bQ<ßz|¢ö­ 3QÊK®7ϧÈG·ÜbŽAB^*ÄFë©Í5LÆX²?´ûÕ{3'‹ó {¼ujµLç©·Rx;š¿ds¼rêÈøv5J‘…LÁÑݪý‘ÎñÉõoG¯çMR"XåÜAx3Ô{1,mú|ði{2Ö4''½CÑ Ceè¦$+)Dô)VoC^Ú6l®i»Î›–¬¼müÀ@+%;„°þÑZÇeð»_mÄï¥]I·OÕq³{aRá~ïRÜ>^$„öœ-˜û*ŸW›Ò[zÿÁÛÍØþfñãƒeÁ,â„/RÅe«ƒßdÛäv–­(ÇŸaéºÆÜ+p+ôHT?Œñ8;ꎡfIÓtl>™­ïsÌppvf5õÒ da×Ö³”¬vP¤åª9K›X¥«àûÖ &z”êÊ;žñ&ÚXïü1n_÷RÌä¨<19#Øùšóqi©AmÕc*8‰õI~7ÿ#ÞþژŻ Á¯SXøN#«Ìä™úðÚã6ª­Ô•õmccðŒî<•Ô¼Ï_[°ƒ¯>•£§s޾D#];d–⚦‘3ÅÊz¶Pžã’kESªæì–?kmóÅ_³ïÅ .Âh#ž+ÔÜ3*˜ífŽê@0ÌR 1‚Ä@É/Ò–#-­ö¿þÔŸà¾óôï1ô²Ž7Ë15“iÍÓÒ×½XÊ”^­h¥4åÖײoGø0=kñ™Ÿém Q« éXHõè3r× rTÐ÷ð–‘· ŒW,™ïЊ4cZÂLô©@¼ƒ¬™èSEØ€ãŠÍ°H½©íY¶uÆ(›bŽ‚¦íšò¤4ªÓÂ4Ò | ´a2”êÑË2³ Õ¦rÎ%Gõ¢8ê"£0"µHâœÑBi0 '¬byõªÙ6ÏÔ_ø&·ì≿ü-ûAøÃMû ßý·L7BT“Ä”ùFßc)òmçT‘å$£I„,Ÿ¾ò½l¶ªKd~ÄÙÔc a)?z[ù/?UÓçØþëÖ?> ( € ( € ðmoö¢ýt ë]ºøÓá»}›£Ñu8µK†Üêƒe½±’Wå;PàeŽ8x¿nÙ†` ®Hÿ±wWûm@¯…j/€>2ûöGÄí.ßì{<ÏíÅ›HÝ¿v<¿µ¤^gÜ9Ù»nFq¹ré^øð÷Å·òé~ñ߇u­N8Œïi¤ê–÷R¤@ª—)’3¨'ËÜPe@P@P@P@P@P@P@P@P@P@P@P@|eñ{öøñ:À¾…áØ< âˆ!òí5O [Çi!dØ&³P!•7Ȉ +ÕDª£×KV“ÞëÌùüưøü ïnû­ŸžÏ¥ÏÏOÿÁ?¿i ™¦ðñð~ÜÖöé¥_‹+Ão󕸚;‘I¨dI¤!œ¼ãÕ¥›Aé5càs±1¼°ÍKÊöŽŸ‹>F»¾×<+ªÜè^%Òu [¶Ùö3Wµ’Òâ È®»â\£+ À÷¯V–&2\ÑwGçøìŽ­ ºu ã%Ñ£~ËÄQNÞ3ê uFªgƒ[/”:¶°§¾~•²¨yõ0mt7"Ô7‡â´S8§‡¶èÑŠý†0õjG4¨.Åô¾$rÕJFŠZΛ¥ø—I¾ÐõË(¯4›Äò涘pã¨är À‚@5©SÄÓ•*ªñ{¯ëúGfYÅä˜ÊY†£§Z›¼d·Oòi«¦šjI´ÓM£óCÇŸ üWðÊô®­Ú4)f0Újðã˸ãp ¹&7Æ~VêU¶– º¿%ÍòLF[+Í^ ÙK£ÿ'äû;]+ŸèO‡ž(åLDb¥:O⎶vvJq¿ÚŽÉÇ™BRQ9»[¥u<×ÍÔ¦Ó?kÂbãR7¹}e÷¬\OF5K -C‰Ñ¤¡óJÆÊw$÷©±j ýä÷¥bÔî›Ö€æy |Âo40™>´ ˜2}iØ\Ãr(°œ„-NĹ -L‡!…騇1¥©Ø—!…©ØÍÈŒ¿½;¹‘—§c71…éØÍÔ#2U$g*ƒ Ó±›˜ÂôÒ!̉ŸÞ©#T"/Uc'1…úÓHÎS+»U¤sT™MÎsZÄâ¨Êœ[D󪻗Mò±®ªhðq’²lú‡F¿¹±Ñt‹)ÆÙ­íb‰× í*€‘Çjù,CU+NQÙ¶ÿú)§S —áèUV”!×f¢“]·ìX—VwYrΡ‰<ÛÉ$óV‘ŒäcÎã‘ZEfC¦jKÕ-/w¨ÿ1ôü:ã®=«ÙÊ1ŸQÅ«zlýçmíä~mâ/¾)È19}8§Q®h]'ïÇT“m(¹+ÚêÊN÷WOë/ë uM¼€AÏZý‚•K£üâÇá)5cÔt}@#ª³àZí§;3‹ÃÝ]#Ðlïfºã#À­I›QÏ‚5iœr¿k:H£žkh»œ`âÍ8ïTs´\‰‡CTc$\CTŒZ,«gëLÍ¢QÒ©ÉGjbTÔ äL”š)2\Ô–™^HÍ&iҡ楛řÓ!9¨gDdd\ÂÜk6ŽÊsG?r¬¹ù«&wÓi˜2m'&²lî§œíåêGžsYJV=4\Ž?PÕ° ç”Ï[„¹ÆJçQmšl/pOü´^·ñwàöÏJññ­*ZCÞ~[}ÿåsô|›€±øëO½Œ?¼½î»GGºûN:;«›V^ ÕµSw+#d¸þy¯*y­y++/—ùŸ‡àª„Ô¤ç4º6¬ÿðŸÜÎ’…6“ík˜¥‘‡÷€ü…sO^¦ó—ä{¸nÊð—öt#¯{îæ½¾EÿøSz Ï£ÄÌz³I¬}¤ïÍwsÑú¦Ùª^Î<‹eeeè¶êÍý7Âz‡l[OÑf’ÞÃømï#–'b¾Bd±'n2O9®º9–+Zu¼õû¯{|ŸÌø+ ÍêªØ¼$\×XÞ ì½çk$’潺ZìÆÔn¼QáÛ-OQh­¯¢†.Ë›aò» dŸsØtæ»(gX´ù]¥~ëü¬|ÞkáÔ§í¢ªQPM¾I·ukëí9ö¶–¶úßKpÞºÖ©>±¨¬GS¾q$¢Ø‹€ªîª€I3_Þf°³ÀÆÚ¾S›ÚÜcYçøirU3nlr.'D+†£cß-a8ž®¹çº¶ž0+\“ïáq =ñ¦͵ÌRF N¥HÇc^n&’i¦}¶M•9ÆQz£óÃÅšþÖ®´ÙTù@—…ÈÆøÉ8?Óð¯Æ³Œ±å¸—M|/Xúvùzö}Oô«Ã~7§Æ¹%<\ŸïéÚÕù’^õ•¬§ºÑ$ù’ºß0d÷¯/”û×TŒÉïO”ÉÕeªå3uˆZoz¥W"3‘ÞŸ!“ÄØ‰®­R”ñ$-uŽõj™Ï,]º5æZµHçž7̪÷£ûÕj‘É.øK]CáWÅ}Æ7pÛÜMq¦jö2hSÊèªbŠØù“Ç#Èw®exQHL± ÅÃv.ãoßVüÈüÓø­û=ütøs4?¾kþµŽâ+AªÜ[yº|ÓÉ™#Šú"Öò¹@ĪHÄlp@(ÀsÎŒ£Ðõ°Ù*»Hòxn†®i@ö¨bTžŒè¬Ûq®:ªÇÓ`eÌÓg[h€õ¯:£±ö88)#f4U]¿­s·©ìÓ„R±™©Y1Q<É4d:H„«#A±Ítá±¥5$ìÑâg™M,à :U"¥&šj駺kª}OlðgÄyim§*™ö…y@Æ¡Èúçšýw/Ì&Œ*>«ñëøŸç_ðŒò\Ë„¦šP“²vmÇx½4»‹Nߖdz[êͱZ)8ìAà׬§Øüö¦^ÒD²ê‹6<åäwé¹ßrc…pøJou±ð}ê[] £Jktxo.$“ź-¼²fÖDЏ33sï±*óq2ýìSØûlŽšŽ_Vq^óvù$­ù³êo‡Pª¥¸+Áƒê+ÚÂ-Ì8†m¹ix2îXÓn#ô8y$ÇszR©&zz_ƒ]—GÎ:m}´ɧt.Y—·ƒ犉3jTõ8SW†w’AÍsÎin{l,ª4¢ÂŸÚ+Á:‚~#jrxfò£ê³KvštQ¬٬͹¡@QÞ6‚Ž7ä9å = léÐ’}\WÙ¿M4·eº[­›ÿF|-ͳ|Û†p¸ÌÒ„£oÝÆ¬Õof’s\ÍÉÉ=''xÊwå•ù£·“y½xSV?UÃUç7í[iÇQ\ú<$­c£·!€ÏZâ™ôøf¤8ñÅ`ÏV‹©ŠÉð±i8ÅfΨ£ê*ÕFu\ÀëZÑÃÖ¯e+odßäqf9Î]”òÿhbaGšöçœc{Zöæjöº½¶ºîBÒJáóì¤×}<“R*J“·“û›Lù,_‰ü%ƒ­*qñr_ʧ8ꯤ¡EùÙ»=©Q#¨ò •É쪭tRáÜ}Wg6×ésÇÌí‚Oåÿ×¥®ª[r÷Öÿw¯ŸùWÇì¦xNu…Ÿ·þ^hòoüÿïð÷Óox'øg­ˆ·A24™ådR£QšÖ§ ÖJôê&üÓ_æyØOòê•q˜IB6ÑÆJnúif ’µõ»ímn¾ßý…ÿfÿ‚ºÖ»wñ_öœøƒàí+Þ½éÞñ¯kju[•Tqqv²¸ h¦E È–Ee|"4saC(¯AóWƒüÿ-_3ñ*Ìáì²¼L]ú»Åü”­+ùÚÉm­íýxRðF©á-ãáµþ‡wàX ºd¾– lI„G„˜ÂFc1í^fÞ1ŠìååÒÖ>iUU¿x¥Í~·½þgU@€ ( € ðŸ?´ŸÁÏ€V ?Ä_[Ûë2Bf´ðíúN¥| ÊSË·_™QÚM&ÈC€­"æ€?&>1ÿÁA~3üTmCÃÿ 4æðƒfó!þÒ ³ë‘93æýË]ѼM¶ ÒÇ$yK‚ |»q¤xÇÆú…®³ã¯ë~#Öam£¾×¯¦¾™! Ì#JÌÁC;¹ÆXžæ€;ý#áøE_Ü~”ߨø *“úPü>V0Ê€qðÊ)”«Û)ÔP¾xãOÆß‡™ŸÄ7>)Ðe—ÌŸNñ$ò]9ÉqŠå‰–6ÙU´j]›Ëbh쟇ŸµOÈ%¾ÿ'Ÿÿ$K2ø¢Å¡µxCêи,¹ä¿ƒŽø?C]qÏ+¦¯oŸùŸ=[¼¦¤$©Ö¨¥gfÜZO¥×*ºòº¿tRŸÆ·ú|Ëö½CkÎ÷‚`Î8ã @œþ•× þ<Þý;/'Ñ~gÏb¼!ª©7‡Å©O¢”VýZ”šÓû¯¶›‡¼]£ké¶ÆëŠ»žÎa²hø\åOP ¸esÀ&½¬.:Ž-^œµí×îýv?3Ïx_3áùòãi5ÙIk½­.îͨ»JÚ´Ž¹%¸®ÔÏš”µmKñ“{¢kvQÝéW‘ùs[Éœ0ëG ‚  €AQZr\(CÇà3^«NóÂ{ñíö¼û'ò×[[©ý{À_H\¿ax‰*Û·:OØÊí(ßYJ]y¯¢äæ¯Ê¼¥žÚâ{K¸$‚òhå·™ ñSÛÏý“s>: wõ\þXü½+ïxs1s‡Õª=c·§üžZt?’|gàêx|OöÞ>íWi¤’JvÝ[WΓrÓâM·ïiô†™¯+ÕÛ¦kìaTþmÄàZ»G¬iWîÈŸ6å=®èHù\U›:û{ã€7WB‘äÔ t–Wøç¶‹<êôÚ:X¤ÂŒ¶kdyÒŽ¥Ä‘HªLÆQg;â/ˆÞð`™|Uâí+L¸ŽÜÝý–îéy"¾d‡;ß%XªI “Åsb3 .þÞ¢‹µìÞ¶ò[¿’=¬£„sÞ"åyV ¥h¹rsFpRvÒS·$mtÛ”’IÝ´µ<Rýµ~éÚÅ•Ÿ‰5[xöí¿°±b—* Ú&–7à’§rAÆF ñ*ñ~]Nn1æ’î’·âÓüÔ0_G>1ÆÐZ®;Þœœ–­jéÂq×ui=½Òãõ¿Û£DŠò$ðÇÃJÿO1ój—ÑØÈ²dåDh“¸Úwn$Œ dðWãœ<%ûš-¯6—à”¿3ër¯¢Æoˆ¤Þc˜Âœï¢§NU¬µr”©4ï}9Z²Nîö^câÛOâž¡&¥†ü9 höÄRÝ®[Ë›V)‚âBË0l²æ-£€C`çÊÄqÎ&nJŒ#öݵóºOËÝûÏ¿Ê~Šù.¥˜âªÖ©yYÆœ$¯{r¨Êi5e+T»Õ§«yÄ´çí¿â'Ô 'Oÿãæ>/ÌúUÿÉcþGÛSú9p3Öxü«_ÿ–Ž­ñs㹨\jwß«àÇeøxá©et\c}gÔ–®ú΢”žú]»-’Hç5|@ñŸq¤kþ?ñ6¥¥\mól¯õ[‰á—k]ÈìTᔑÁö®z™Ö2´*U”¢ú96¿3ØÀøgÃymxâ°X TªÆö”)SŒ•ÓNÍE5tÚzê›DZˆ|eá[9tï øÏ^Òl$ÌöÚf£=´m!*ŒbFzáG¥gK7ÅáãËF¤¢»&×äάÃüƒ7ª«æ8Uæ•”ªS„ÚI·dåívݶ»}Íwø‡ñQº|Pñvì5uÿÅÖË=Çõ¯?ü _æyòð£…>ÎU‡_÷—ÿ"Voˆòqñ;ÅGë­]ÿñu_Û¸ßùÿ?ü ÿ™ƒð§†SÓ+Ãÿàšü‰ÛËûDüu ïñ¹#ÛM²ÿã5Þ¸«2—ü½ÿÉcþGÊ?x*ŸüËÿò­oþXzû[x®1uÿ ƒôËÒÛ|Ÿìéå³Ù×víþnìü¸ÆÜ`õÏ¥2«¯¶¤Ÿ£kóæ¿à|eôlËß/ön:¥;^þÒ1©}­n_eËmo~kÝmmzfý¨ü%4=ׇµØîÚ52ÇA"#ãæUc"–çhÈì:W ¸¯ $¹£$þ_Ï‘©àP©%JµA7gy¦×F×#³¶é7m®÷:/⎅ãTøp]Oq…óa–Ýã6ìFv»´x;K{ds[Ë<ÃNŸ56ÛíoÍí÷\òèxYáñN†21§þ.dÓIÚñIójµJJ;Y´ÎçKð<šÜ‘\j¬î½VÜd'PA#¹'¦8Ç5áâ±ÕqNÏHö_¯sõL‡…p9 y©®zŸÏ$®´³åþTõóÖÍ»#Ü4/Ù@‘âÜ t®#éOLÓ¼!n1ûŸÒ€:¨<+ÇîhHxZ£÷4ø^ cÉ•p~5ð6…¨x{X·×#tÒ„-,òÇÑ*|ûÆ9R ã8ÆJÖ„§‘t÷¾‡iK[V8·j|­É­ÒZßNÖ¾ÏÑìxÃoy0Å<©—8Å~‡ƒ£evqcÏ'½¬|9¥ñË^å(•æYêÐÀ"E@8»-cæå.gr}£ÐSº$O-OðÑ õ –Ý]N4­r”œNSR´7ŒÑèaê©Ùýî+šq=Ü5[c¯é«,R)^q\uat}.á$ω>7øA®tçÕmãÿJ°ËœóEüC>ß{ð>µðüS—¼FÔŠ÷¡¯Ë¯ùüêOø¾96}y?eŠ^Ïwe;ûŽÉ;¶ýŵ¹ït“¿ÈÌÕù¢Göü¦@ÏŽ†©#žU,BÒZµ U+<ÃÖ­Då{^ãëE’x›$º<Ö±¦qUŤzçÂÙûã§Ç[˜aøMð¿_ñ ¬—ÚVÞÛÊÓáž8„Ï·Ò•·‰Â!^E'z’êð¡)l+›R£ñËüþãô_áÏüÃãˆ>Ëuñ7âW…¼!§ÜX-ÇÙô¸¦Ö¯mn[aû<Ñ~â´4¤Žyr»Õ·Žˆá;ž-~ OJi¿Àý ðOüköAð¯ö§öþâŸý«Ëò¿á%×d‡ì;wnò¾Â¶Ùß¹wy›þâíÛónèT &¦mŠ©ÖÞŸðn}‡à?Ù»öøaqáýCÀ?<¢ëZ%¸¶±Ö¬ôkíSÊ0’oJ™ÝÚ2Êò3—}͸±cb¶GëÕ©~y73Úꌂ€ ( € üÏý ÿà–³ÏÆq­xÛþoúO†­ôɱä¯ïtÝÉâ8œ/ÙÚ ¼­$žiàã:1™èa³*Øw½×ŸùŸ‡ßµ7ìsñoöDÕôÉ‚‡€¹å_ùCÿ©ÿÊŽ{RÕÛYÕà»ù²‘* ï½tásyšöÔÓI;ko^÷<<ÿƒq|5—cg Jqç÷j͸ý¨ÅßÝ};j}ð»Ä–—Ú}”‹å^Ä¡Ac‘&=¯µ}f ²”T^çóïåÕ(V•U¬_à}Uá벊Ÿ9ë^Ý)—f“oCÓíu|"‚Ý»×lf|Õ\.ºŸUwqMÌÍa™Êêþ#ŽrÒ zÂ¥[¦.sjÈùoâßÅ”Ð4›†·–7Ôfù-áv?;w8”ž†FE|§çÑÊp®¢iÔzE>¯¿¢ÝíÚé´Ax3á-3ÚxJ‘”p”ýêÕ"—¹;$ÞœÕåÄÖ³ä”a$~eüGº¼Ö­[T¼sqx'I;ãpqí¼Aé_à±Uq¹Õ¯6å=üßü·D´Gú-ÄÙ'áü>*¡t0í(¥öbVå&œ›nR—½&ÝÙåÍ‚=«Öš?>ÂÊÌîôÝT¼X¤ŽÕÄOʼŸ(#ÈÏ${Š)希Eœcdú½?àþÆñ®M“óBµniÇxÇÞ{Ù«ü)­nœ“Óm¯ÓÇáj ­Æß\ÕˇñO¬~÷þG-2(háWÿÿ&]¶ÑuYÝ¡·´’y•wàcëÎ9cþ­âäíÇüMxÕÃÔb¥VRîÔçPí¬~ëOµ¯¶[©ëù߯·­tÐáD¦ž"iGÊíþ)%믡áæßHŒ¢ŽK)ÃN¥^žÓ–Z=t”¥+;{¶Õýå¥úËo†eðCÎÃÓð¯^Ÿ`ã%)9Ivm[ðIþ'ç˜ß¤_Õ£*TãF”½èÂNK[éÏ9Ç]âôzYÙ­Døo*±ÚHIõ×¥K‡°TW,h§ê¯ø»Ÿñ‹‰³Š­lʤZV÷%ìÕµ >TÞ»µ}•ì‘Óé_ neef²rݯZúžâ¸®VS=ÏàÉ™5žÓþÐÅuÇ/¿Cç«q‚ƒÒGQgð^Þ07B£ð­£—$y•¸ÆrÙ-¯Â[°LcðZÚ8£Í«Åue³7"øe¦&BNzp+EƒŠ8åÄ•å³,†–¤8›j¾§?õ޲ê4ü1³í?îÑõ(‡úËW¹Ÿ m™J¤k‘ê)<*ÛøkûCü#ø©“†ü]iˆoò©á½ZD´Ô|Õg’5ŽfòѾi!2E”|9Úqâ×ÂVûT¿/¼ý;+â ·9‚–²“í{IzÅëß]´vg¶W9ì…PäíÕûuKáIu_µ‚|nwZøƒÅv2ȳÚÚ¸ÿ—¾¡äê9UýöL“:…¨êúæ·­ÝÜêÖ¡;Ý]ßÞÈÓMs3±g’I–gf$–$’I&€>ƒðç†B*/ô eѼ=÷?wúP¦éú òPoa ð>OÒ€:8_é@eðÈ`A¥r·ƒVEuxr§Ú€=à‡Å-OàåððξÓÜü6»”¸P ¾+¶ZX”rbf$¼c¹.£quôCÞ#Ñ<]¡é¾$ðæ£ö‹™ÌY†H ©••VF•”«A·@P@P@P@P@P@P@P@P@P@P@=ñGã¯Ãß„fÚÓÄú„ók×Qyöú.™Ÿu4[ÂÁ!rXƒ#¨o-Âî*E|ãïÚ3â÷ÄÖZ5Ùðo‡_iû.‰;É?Õ·ï/0®0èÄyB,«•mãšð½3áͲ XTРª[¨Ï—øb€%oÁýÏÒ€3î¼!>çé@½ïƒ `À§é@}«x&ÙƒƒJñß|<¶Þ·Iã`ñËÊѰ9HäyÍ8ÉÅ©EÙ¢*Ò…xJ•X©FI¦šºièÓOtú£šÿ„·ÆXâ¸Hu>,ä\æ9ö…¨”dp@$²³œžr=œ6yˆ¢”j.uç¿ßþi³ó\ëÂÌ£2”ªàäèMöÖ½Ûäv{h”e­,´iûƒ<_¢ø¾Îk­%œ<åÏirÍç”0ÀdH<Ž õX,m,létÝ=ÑøpÎaÃ…‡Ç%ï+ÆQ»Œ»Ù´ÖÍ4šÑÚÍ7èq[£ã ƒ]é%:Gñ_àn‡ñN¸º±‚ÛNñŠ~ò QcÛö† GpTeÐ…P–L27+xyÎAG5¦ÜR^’ïå.ëÏuÓª©xkâæeÀXÈS­9VÀ=%J÷åWoš•Ý£$Ûn:F¥Ú•Ÿ,áù÷ñÀ¾&øU¬Ûèþ*‚51ù–·ÖÅžÞí@¶9åI”€GYIüÓ3É19eE Ê÷Ù­Ÿ¦Ûuÿ&íîñG#ãŒ$±YmFœ]¥ ¤§ÎI9+I+ŦÓÕ_š2K•·½Wiȯtš?MÃcã5£4Ò]Ø9â°q±êB·1i5›Gd*\œ5MŽ…"Ej–¬i\vE&´˜ Ålaj,KÝÜûU{‘“Žôìg'b2â©#1…Å;æˆZAT‘Œª§c'1…ª’3”ÈYê’0”ÆâšD9ÅUŒ\ˆ™ê’1”È™±Ò©#)L®ÏŒäñV‘Í)Ø¥÷«Q9åT®ò€:Õ¨œÕ+$gË;TKHÄU,{+hÁ%w±æÕÄIÉBš»z$µm½’]YÕiž2'Ÿ¬†Ýž-‘øÇûD~|ð}|}Ÿ-¿ü¿àŸ_•p—´µÍS¿H'¥¿¼×^©Eém[»K³V"Ç…UUÀW˜Ó“»zŸs *QP‚´V‰-K¢ÊM¢u˜Ã1§ÊC®ÈÚ_ST¢e*Åy&½Z‰ÍRºFlòîÍmØòñ¹¶1f»kixÛ!ȯC 9RšœwGÉg˜z†¦º¼fš{}ê÷WOTú4™õÇ€þür×¾·ÆkO†zýçÂèî'·mz<äÄ*ï4ÁTù¿gŒFê÷<•ud/¹J¸Áf^Ù{ÊÇòÇðS˦ýŒ”ãÝ&­§Uª]vo»µÏHð‰–k8\ ~-Ì&ï (ù$¿[Ÿ«åGžÂÓäÄQvÝï:’NÚiû¿f­×TÝÛÖÖKŽ×þ(|Rñ_œºçŽ5W‚ksk-­´ßd‚hŽì«ÃÔl†`IRHÀ9åâ³üv*ê¥gf­e¢kÍ+'ó>ó"ð…r`²êjQ’š”—´œd­gÔæ”lÒjÍ$õZ¶Î=61Œ®kÈuÙú%<® t[ŽÂ5û±Ê³u›êvSËa¢Z[?ök7PëŽ Ý …ž{TûCu‚¿BQgŽÕ.¡ªÁyžÔ½¡¢Áûî){B¾¤»Ù=ÐSm=©ûB~¦0Úãµ?hfð–èDÖ½xªU ¥…ò+½šž«Vª3–x(¾†Ç‡<wâ}J; 4!Yq‘ÿ¥w`éK+_E¹òÜEŽ£’PRµêNü«¦›·ä®´Ýíݯ¿>|3´Ñì­`‚Ø,h=9cÜŸz÷ãËÈ«V©ˆ¨êÕw“Ýÿ_Ò> ðÿ…€ û¾>•FG«i¾(òø êËÃøQò~”ÐA ôù(Lh ù?J®úû¥rž+ð|Ú¶­é–ÁâòÒkxÚL… èT@'>•­ ªua9lšs83\,ñ¸ øjM)NоהZWßM{,ø?O) Œ~¥‡†‡ðnoˆ»lú@ƒ08êSGÁc%vvh™íZ6rBŸro*§˜ÛØ“Ž¢Žaûº4dsT™„éõ3/-„ªN9¦ÕÉ„ÜÂêvXÝ‘\ó‰ëáëže¬ÚpÜWHŸGƒ«±óÿ4Àé()• ðEyXˆ{“blÖ§æ§‹t“áÿjz^ÖXb˜·wŒò¼÷àãê+ñìÏõ,\è¥îî½ùm#ý!à~%|Oa³’N£\³³_tm¤—+•¹¹l¬¤­ufù7—ëDú9Ö±NIÀÏ5¬`pÕÄ$^ðï‡üOã]rËÃ ðæ©¯x–÷Ù´Î[Ë«ˆÒ>Èc íµØà*’x¶…'-<ÌF:Ó”‘úÙð?þûñ?ÅVözßÇÚø&ÐÜDÏá½#Õ5 `Y]fI.þÏn숡¹½Ë¢”(Ý´ðŸÌ|Î+ˆíE_Íéÿò?U~Á>?e„:ÚL 4¿ßÜcí:×ímõ«™ö¼Œ˜Y#òaÀ—gî"z¢oÞʺ£JÙlÃ]ÝÊÞšjV‡P-ORÓ´];PÖ5BÚÇH±în¯¯%Xa¶…³É#± ¨ª ,HM _D)IE9IÙ#ç/þٲ³¿µþ5xzëíÞg•ÿô’k{vmÏ™ö%—ÊÎñûwa¶çkcháêËhžulßBÜõ–½µü®|Ýâø*/Àëíûo ø7ƺÍí§ž–µ¥µ¥ž£"î·˜Ó™bŠBîhwª¶L{†ÚÞ8 ²Üòkqn•ÔT¶ÑYþ7·Ëäy,_ðU­AúþÎàÜÙŸý±­–Y'ö¿Í—QŽÔ¿òoø“Eÿ3ý¤Ûüðëþ¦jü›[¬²=ÙæÏŽ«­¡ÇüÉÏü·ö“ÆW¿7PÿäÚÙqîÌ××ëþ?æw>ÿ‚¡|C±Ó§‹Ç?ôMcV3–ŽçBÕ&Ò¡Xv®¢•.X¸`ä¸p`6ŒÙË+fG]o7âŠ8 Šæ—w·üÃæ~Vk·>1øŸâ9ücñ#ÅŸˆüK>ào5IŒ¦ÚG“Ê…~ì0‡–B±F5ÜB¨Wç9Ž{[&ç+Ÿ“fÜIˆÅIʤ®néÿ46/eÒ-^ôapÐ!pF0wc9úWÎVÎq .š¨Ô{]Ûî<ñžqC ,eHÑi§9(5+ó'ígwumnï¹è¶žT~ê¼Z˜ù7¹òs9·¹³† +*¹eŽ—s’Y”û“¶ì0ÓŽa%Ô#šMu9=cÀšuä3[ÜÙ$±H¥YC¨ õèa³j´¤¥ Y£×ÁgØŒ5HÕ¥7EÝ4ìÓ[4ú4|ÛãZyK‹½6²¿PJć÷.xà®8éü8ëœûŒ«‹*ÝCù£ß¯ß×çø·poŒy–]V³ûj7ÖÿZÝ©_W®Ò¾É'Ïš6]é·sØßÀð^@Ûd‰Ç*Ï9èE}Åá^ ¥7x½™ý‰‘gXlÏO„š9«¦¶äÖÍ=Sºi4nÚÞá‘äVù~.yuuS^Wºî¿Ín¾ëê_põ1Ê¥„|ª´u§6Ÿºôºº×–IrËt´—+qGÓß ß|6³«uÁë_«àõIŸçç+JPg×:?ˆÖ£BáœËW½Nµ‘ù>3.s“vÐf½ñ“ž¸µ´ñ´–·W dŽŠI˜¨8ÜB+äqœg ®aJƒJ¤¬ßõÐxÇæ°•L.hÇFî’¿kÉ«¾öÛKîŽ/Tý¤¬Œžðýýä¢bžeÛ¥¬o?¼Có·'n•N ÎÁçžo~î-úéþ’=œ/‡U“Å׌¯h§&Ÿgð­5»Rjû];ž)â‰ÒæíÞüì¹Õ$IµI%¼˜(_6îF™±é¹‰8äþuÅS-£Š’x)½¯$›·«>— ƹ–EFX|«<=6ùœiÎTâÛI]Æ +Ù%{^É.†Ó|$Ðï#"{5*Ü2‚@aè@íT²<ÓTbŸ¢3©â§8¸K1­(½u&ôù½Iôï‚ÞÒã„iz=²KvÌStƒ9ÏÎÙnärzqÒº)åti[ÙÁ]}ÿ~çãÜÏä±X‰8Ê×W´tµ½ÕhôOmõÜêl>ØFáæ@ÒÀWLpQOSįĵd­dz €´Øã­¯£k®8X®‡_=¯'¤è¼hBÇ!T ´XdpË9¨µnå¨~BòtP>•KŒ§Ä2JÉ=¿ÃÈÀCCA[,'cÌ©Ä×™µ—‚¡DMÖÉ»JŠéŽv„18i©Sšºkf¿¯¸Þ¨:ÉÏÛóöÛÕ>ÞjŸ>\ÜÙüA–Æ»âTV‰´hfdHm‚n)ŒËÄJãa2Ð~?x7‘޹cÉ$PÒþðìCËùJ÷]DŒJõFäùJô?D/Ë@½†ˆ8ù(¥·Ñ%mÁ¡©Ù@“ÃÊzG@w~V¿u’(Ï5 A"º<#¶('Àž?Õþ k7sÛÚÏ}á+רi0ÜÄ<è3€& Á 8XŒ# é垣gk¨i÷PÝX]F³Aso ’9£` º0ᔂ#‚ Y € ( € ( € ( € ( € ( € ( € ( € ( š~+þÕ þý»KµºøÆñDeq £Ì]·7rIÇ_šTÜ”E|Ï«þÝÞ3½ÒnbðßÂ}?N×o“w©ê’_ÁÌ o…"…›+¸ H¸$@Ú@<7ƵŸíCâ%°:/‰´ o3ÌþÀÑb—í{¶ãÌûa¸ÆÝ§6}öÝ»åÀèý½?h ûµøëIIÑ®­­¬¯`–hC é¦éÄnW 9G H%[ ¯üâÞÏX´‹Åõ+Oÿh½Ñõ¸ï®bÂ1]–òA ¾\(9•p #qHè7ÃŒŸ >2é3k? üi§ë¶°cíÀÍÍž^D_>Ú@²Ã¸Å&ß1x]Ë•Á ;ã§Ç=3á&’–:|Pê^>Ôc-§éLIH—%~Ñq‚ˆ@PCHÊUHÞ0Í}Zñ.³¨x§ÅÓê^!Ô¥óîonH/+`À*€ª¨ ª¡T—¥ø\(Rc ¾ßÃÝ?wúP Ð6¯Üý(Ðzü”›u¡|¿r€9{½ ¯ÉúPªhÝòPšjþ ÿJñ_xT0²µ|ý¦ë^ Ö¢ñ‡¤òo"Èe ”™Xä^êp=Á‚ta±50•ZO_ÏÉù[žNw’`ø‡<:„¶}búJ/£_sWM4Ú~[®üyøå¯tðøŠßN¶b<»[->Ý¢@)•]ù#',y'`Tã8Ÿ1¥SãQOk%oÅ7ë¯àkþp^a„Kêò«(üNU&§«m]BPº&¢®–¾õÊ+ûAüw^ž6oüXÿñšãÿ[³/ùûÿ’Çü¢_G~ {åïÿÖÿå‡ âüJñ·ÛÓÅ1Õï,¯6yövŠÖM›vÿ£¦Ø† +p¿xnëÍpâ³ì^.êµVÓÝ_M<–Ÿ†úŸQ‘øOÃü>éË.ËéÓ•;òÏ—š¢æ½ÿy+ÔwM­dô÷vÐë¼ðÄZÔbææù´¨Ø®È¥‡ÏgR2I]ÃgQÁ9àäþ¾ ‡qè9â=Ëí¥ßÏUoG¯{ñ7ŒÙG b£C(_ZµùÚ—,NÖ‹q—3ëÍrÖqr»·â=Zðn³q¡kö¦ȾeeÉIã$âHÛºœz‚ @ùÌ~_[YѬ¬×Ü×uåÿ õ?já>1˸³.§™eµ9©ËF¶”d·„Ö¶’¾Ú¦š”[‹MÑŠpqÍy²…µ¥ˆOf_Ž@{Ö2‰èSªžå€{Šƒ¡H]Æ‹Ì`,qÖ‹ ÌŒ±ªHÎR".i¤dæÆ3š«ÊdLôÒ1”È‹Õ$e)‘ïUc2#!J&n£#i 4ŒeQ‘—ª±›˜ÒôÒ"UYê¬c*„Eê¬dæBÒb©DÂu,S–aÜÖ±‰ÃV±BK´\üÕ¬i¶yõ1SRÏ@Õõù kXÃIp¥Olázž°ã­aWFŠß™ùŸôüWÃùže-`éBú¹¦ŸM£»ÑÝmf¹“;=7ÃÖ[,˺kÀ1çIÛ ghèëɯ2¾2¥uË´{Ÿõo#îr®Áå2U•çWùŸK¥~U²_|¬ÚæhØc\ÈöäìWcV‘Í9šLw«HæKÚozµšUНry­:˜«%»àÖ±¦yÕ±«¡—s~µtB‹g“‰ÌU5«?Jÿf?ø%ÿÆ/‘øƒã-¶«ðÓáÔ~\‹ý¢®¯«br’ìŒÓäŽB&:¼,‘LŒÅ}:Fµ‘ðÙ¦û´uü¿àŸ¦ÿn/ÙŸö%ðÖ‰ðWá'†m|M¬è0=¥¿„¼)}YèÆ;.Xõ ßÞ4w%¾Òì»&™¤F3l2‰¦¥xQÐñp™^'1~ÑèŸW×Óú·cð â÷Çügñ¶§ã»½Cð†§ª0ŸPµðDw66÷·Ym÷.²M# _pßµ•]—yRìîØO6Ä(¨Bm/-?àž¶Ã좥w‰ÄaãRo~d¤¿ðîßMí}õÕž9o§¢€@µäγ{Ÿ†Ë¡h£J;5šÂUêSÁEt.¥°«'3Ч…K¡m-¸éYº‡\0¤ëmíPætÇ YK|•.gL0ÖDË=ª9•Ôve³òÒæ5T,Ö×6:ôü¼ÛÜ8ÏÐãþû÷Q_žqF´§ë÷£ûÀŽ$PŽ#&­;sZ¤›¥i«îÛ\­-tŒžšßÏ>|ø½ñã\›Ã¿¼ªø—Pƒi–Ñ;k-É#§Ú.¤+ Ä2„ów²•\¶|½:2žÈýã™ÑÃ+Ô•ÛOÙûþ à¯ýŸ^ý¤U ‘v }ŽŒ­ç)羞1øµ>KŸU«¥eÝïþ_™úÍðßáwÃÏ„µðgÃ/i~ðÜ[ìz\?>E"ó¦¿4Å"Œ4²‘ö‚ÌO5Õ¨«#éVu¥ÍQÝå33È~'ü}ø3ðfdø™ñDÐîÒîF™4þmôÐÉ/”²EgiäMá†ä€Øäà+p§)ü(毋¡…W­4¿?»sóÓâü[ÁÖnÓ> ü:Ô¼Az¿k‚=kÄR >Íd\-¼ñÀ›åž&;œ£›g |¬Çg]< åñ;?‹âœ=ª1æzêô^^oð>ñÏí¿ûW|Hþ×¶—âxkDÔ<Ÿø–xFÕ4ÿ²ù{în¾k´Üɹ¿~s½—î•ÛOº¹òøÎ,ÅTºŒùSí§ã¿â|Îúþ±¨ßëÅÍÅö¯;Ý]_^HÓMs3±g’I–wf$–$’I'šî†->WœJmÊR»gCiáÇîJèÈ«›y·„º~ëô­•Ϋšù›°øMpŸ¥h¨3Í_sR g‡#éZ*4óo2òøK?J¯aä`ó[õ,/‚·Œù>âŸÕŒÞso´9ü Usö`GÒ«y gw–žÕtÕÕ×CÕ5M(j¶Ré·ÿÙ—OoöÛIqæ[Í´üñ>ѹ*ØÍ[/…eË8ÝΊëàÛtªZêÛ½»iÐáíþMáüÉn“K# 2®u÷Í|fmÀ |e*nTäïªwW{]>‰ô‹kínÊœA~“i?+þ­þ‡[¥êº-’“ª$öf02Z1ï·`'p:×ä9φÜA†°±h¶õŒ”ZKne77Ù9ZÏ]¯åbp¸šÏ÷ Jþi}÷·àÙêÞ»ðî¶ñC¤ëWW-ŸìÑL¦TN9hó¹pX0N5ùŽo•æ™EÞ; :i>[Ê-E½tRø^Í«6šWZ-˜ÑÆ`Ó–"”¢¯k´í}tOg³µž«Tz]¾ˆ–¾jX–ÙóÓÅ»šÑhƒûµŒ± ç–)’6ˆ¿Ý?Xd,S(]h êNÑZCÓ6§qgªøa%GzX|{‹=|.dà÷>[ø­ðzÛ½åH5¸ùScÇ]ŽÞýAäwïx‰eƒ’§SZouú¯?Ïîk÷ üQÄðŽ)S«yáfýøu]9¡}—m¤´v´e‹¯¬u S¼Òo!?lµ`®#ù‡# çЂã_ªacý¡IVÃÅÊ/ÈþÖÊ8Ï*Çàhf1®¡Nªn<íEèí%f÷‹ÑÚë³i¦ý³Á~=x­¬4ßì’HVY`”« ÁJòpG†O¦kô\§1©R”iÖ¦ÔÖú5=­òºÖú$.xƒÁ˜<:®/-ÅÂXi»Á)Æn-¦Ü]¥ÍdÓ´¹d”yS“•Ï@Ö>/&³Ñ4éα•âüKÔ– 䓎ƒŽ¹ÏcëÔÇò+Akçÿ~sƒá'ˆ—´ÅM{=~Ûòºµ»½{y®L²¾Öµµ]Vw¹Ô.|“ËÉcÓð¹aT—<õl÷±5©`è¬>rÂ:$¿¯›{·«Ôôë=¸TQµ{’+¶4Ïš­ŒåÕÞ•¡Û˜Ž,±êÇ’k¦’ØðñXéÍêÎ×OÑ÷‘òáEtÂϾ/—©Óä·ŠÙS<Éâ¼Íx4Ž1³“Z*g$ñ~gG§xwq ÉëZ‘çâ3 hŽ hjQí[û3ËúëoRõ¶’¿-R¦cSt¶z&æ¥mg›[m޾ÏETìé[Æ™åUÆ9=ÍHlâ þb©Dçgk£V-> ˜Á>õvHÁÕœºŽ¸Óe;WŸJ‰Å3§UÁêR´Òö¹]½ efvשÍVT(·=އswc[L ’¯5œ¦Žªxy'¨‘é¸!¶ò*T×SZ¸y-RÉ´sG§´G/Õ%s:m ¸-aQ_Tz¸9J>ì‹‘Xˆ¼Ö•ŽLU.fV¸´Ysë[]Hóy7teÇbØ2ñJ(ª“ºº35m& È^6PA¢pREa±3£%$xÞ¥áo³Ë"”àr yó¡f}n4çŠw=gáí!wð:ÒûGñF—«ëž ’A$PXK“Gùeiœ/˜$v‹r™UW àX7Ìg9GÖ_¶¥¤ºùÿÃz~Gî¾øˆ²Jo-Ç':-Þ6zÁët“Ñ©;;sE'w«‘ö§Å¿ÚcáçÂïWŸ-ï`×¼?,Q®iit>±u#lHÉ‚¬¬Ê»ZHÒ‰Œ˜ÊWÆT§*Rpš³GôÆGF8Œ<”¡%t×õòiêžSù€†ÿZñÏŠµßø’ëíž ×/§Ôo®ü´Ï¸šF’GØ€*îvc… à*ƒèŸ i;V%Û@CxoLÀC¶€=›FÓþçË@­£iÿså SÒ4ÐÁAZôM?F/Ë@47O’€6­ônŸ%hbƒüš`~JóßxY£.Ëx‡Š<9çC&cù‡lP°þÍ^2Ô%‹Yøy­ÝÏq6š‚ïK’r\¥§Ê;8Xœ¡]ÎIíP Õ”P@P@P@P@P@P@P@P@Wñoâׇ¾xlë²›½^ëtZf …—P˜À8;#\©y!A32#~nø“â/ÅïŠs<ž'ñMÕž™4/hz Écdc’4IQÑX´ÊÛ ÄÏ&7¸]ªÅhOøg *Çh=¨pø2Ýn?*£sáôqùP¨øB¬>Î?*òÍwÁVÎ5¨ÇÒ€<«NðN¥aã +QðÆ±©hô æ-cEº’ÒêÙ 9ŽT!—r;!Áèä‚E}Ÿá¯]ê3CYÔoõMMÕ[ýVêK»‰ö¨E2M!grTe‰8€=³Iðâ Ÿ» ú×BUU:ß·ÑÝÐöÑr€*¾†?¹@÷Ú>Á’œP%y¦'?  CQÒÓk|”ç:®–Ÿ7È(Ë5í6W>X ñ.‡¬ªÑµ|›ã¯ GÊëô¨œ#R.WLèÂâ«`«G‡—,âîšþ¶èÓÑ­‡}€…fÇâ¾;Iá«J›Û§§Oë¹ý#ÃØêyæ]Ks5i%ÒKuk»wWwåi½Ï¢þ|3ú…õ šþ@®©*qmÐŽáºdöè;“ú?pì0ôãˆÄFõšM|=Víw}6][þ.ñ£Æ\Fm‹­“äÕ]<7(9BZ×zÆMÊ.ΓWQŠmM>yÞñŒ>²Ò¼<¶°( Î:â¾î¹Qü¡ŠÌY^æo‹¾xgÆúTº_ˆ´ØåÌnݪ¨žÐ¶ hd ”9U'±Ú2+Ÿ–áó N•xß³ê¼Óéúõº=~ãLß„1±Çe5œiÊ7|“Jþìãt¤¬ÝºÆ÷‹Œ¬×æ‡Ä_x‡áv¾t}m|Û)·=ާŠö0zŽ»\dBIRG%J³~Q›dõ²ÊÞΦ©ìú5þ}×OK7þø}â>_Ç9rÆa-HÙT¦Ýå ?Î.Ï’v´’z))F<¬€†W…:V?TÃãSêtv6·×ì#³±žiÈX£-Ç­kG*Åâ]©So¯e÷½?1ãÞÉ`åŽÆÂ->V“æ’zèãÉZÍ;­S¤³ðgН·yZ%ÊíÆ|Õòÿ-ØÏá^•.ÇÕÚKÉ¿òM~'Åã¼záWMNuóB)§§÷¥+m¬V©ÚëS£·øU⹕KˆHÎ2I¥zKƒ*¿ù{ÿ’ÿÁ>&§Ò_e€oþâÿ÷2ñøEâhÁg¶šDõ…3úuý+ªÇ÷’“~V_…ŸæxX¯¤®&­fð”)Bù¤ÖšÞJPO_î«-5ÝéX|Ö®|š}ÈPqûÏþGÝG„ðª6•6üÛwü,¿å³¤{R³,T)§ovƒŠÒÚ9)Ë]ÝäõzYYüòÆfØú+5t.Á-éþ2ÿ3Æ~>ñD¾oþS¥ÿÈøA¦tk9 ÷‘Çõ§þ¬`?ç×ã/ó%øéůþcò/þ@Ñ‡àž“0±}%ñ«\/€òïñ—ùœÓñã‹cÿ1«ÿÒÿä _ð¢t]¤}ž`}|Âqù×E>ÁRV%ó×ó¹äbügâ|mER®:I¥ouò/ºªúïkô¾ˆÁ¿ø$`¶œVB?圣ýJ™duðÓÜ(x·›ÉÚ¶2ªóU'þf$un³iRí(?É«‘pÆ­/Åÿ™ôsñÓ:9à¸ò? RE¸×9·_®Aý+*¼/…•¬œ}ùÜíÀøéŸPæsœ+^Öç…­¾ÜŽõ½öV¶·æuƒ÷± $Óî^Lr!˜qïcϰëÖ¹çÂôWÃ)~ä{Xó4«Q¤¼ÒŸåÏú³”¸øiâÈŠãN‘·gFü}vççÕáªñþ¿¯oUÉ]€ñ¿+«¦6›–®-;ËÊ2å²ßíI­»˜òø#^ˆ²ÉQ²œrÀƒùVêþ)nãøÿ‘ëÄ_Ȧ¯U(òg)}§êšqÿK³’5Á;ºŒ¼Ž;×\»E^pŸä}.Œ2ŒÎN8\L[ÑYÞ-·µ”’oåú£Ÿ–ñrãð¬cM³¾¶6 ©õÃÿÙâ÷Œ×Sñ'‡¯<7á²ùq¨Äb½pÂ8܇(e ÆPãƒõ™w ã1 N¼\#ç¿]—O·º¹üÿÆ~>pîOᲺñÄ×¶Ž-:ièÓ”Ó´•íMËX¸ÉÁêzÞ¯û8Aá{Xlì-¥‚TP­+dŸæCŽI$žØÎŠô3Â׌c$Ó]S×ç{­}/²ÛCãøCéžåU«V¥*u!QÝÆP÷SÒÜ®.3´R²Nn:É´äÜÖü®è®ë-«Ëþ(Ô“Û·_ç_ á\n ·MsÇËG÷~V¹ý_Â~>p¿Â0ÆÏêµ›JÓ÷ Ûm+TI$’IÉÍSJú6“gå ŽG­|냃q’³Gì”ññãZŒ”¡$ši¦šz¦šÑ¦µMn@ÎM4ˆœÙRF5¢GI´R’OzÖ18jÕ¶æl÷*¹æ¶6Ï2¾*11.µP~l}k®[< ^b¡ÖÇÙ ÿàžßµ×ÅˈM¯Âû¿ h­q-´Ú¿KhÉlé¶u7n•E’8 ¶ \¯u<$žèùl_Ò†‘•ß‘ú¿áOØßöLý€|$Ÿ´ÆßÝøËÆ>¸I´ÝGP…aC¨1‚-3L{–VB òJíüõkuFdëTéá×3>vX¼foSØÓëùy¾ßðÚŸœ_µ§ü;âÇíq«xCÁ×~ ø9ö‰ã‡NÓ§’ C[µx¼’šœÉ!WFS)6Ñâ!çms9$®:ØÇ-#¢>—-á¸QJu½é~/óßÐüû‚Ï€ª å^têa‡ÁtŠ5×hÀ®wRç¯ "в.Åo€šÎS;©a¬¬‹ñÛ=ë;ž<7):ÁÏJ—#xÐÔ´JÍÈê…Ú[zЇ#ª4K+mžÕ<ÆÊ‰zÇ¥K‘¬h¤kÃaòŸ–Žb½Ž¤‹¥´‡…ãÖ¥ÈÖ44b¤†—1^Êæ»i_¹û”ù…ìu1¦ÑÎI+K˜¯dfK§'#Š|Ä:eI¬Î:Usû#2[r;SLÎP=7á_†[PÕR’<Ç ÙGñ¦¾Ÿ$ÃòÁ×—]§_Çòó? ñ?8UqPÊ©=)ÚRÿ^êÛ¤]î›OšÏXŸø/CCÙÏÒ½Óò£è=JûŸ-{>‰¦}Á¶€=SKÒ7;9 ÆßGá~ZÙƒHéòвi(ùhÿØãû”^m 2·ÉÚ€?2ü7gŸ/ŠýŽ’?ͬ}MÏhÓ ˆ WDÝ• yÜêíí÷“\3©ÃaùÒ±µo§’70®iÖè{¸lµ¿y¢µÕ¡çŠºu\^} )á+EuÆW>~¾Æèĸ­ožM\9‡r™OCZ§sŠPpw8 jØÜVéàê9¯[äHàןU_©k3xÃB[˸mŒjL’ª®îÄœgõ¯K™Øý'(Ç:4Üï²=á'Æ/¿³´Qéß¼DÂІÛá=iïKçÍoÝÄZß2Lò7ÙÞ-ïƒ&ð1^Ul¢“VŒy}4>ó+ñN§=J®¢{ó·'÷·Ç¢è}ïeÿCø_c¥ÚÉãO…~9ÓõÒÜZè©g¨ÛEó6Ý“¼Ð³å“˜”JóÇÅ«–Õ¦íÐý7ÆÙ~2š•š—m?6×åþg‰|Eÿ‚µ^Ÿí›„Ÿ¦ÿ–_Ùúß‹®›ýƒ/aÿ®¨»n¿ºç¼u1ÁKíVâŠZª)y6×ä¿Ìø»â'í·ûVüZ¹MñóÂÚ;OÄZW‚ƒi+nÉ–@¸Bn],ì’LêY³µõSÁÅtûÏ ĵçÿ/,¼´üwüO›ô¿HBþç…zß#ŠÎsÐôß¿Ëò~®¨aÏŸÄç ¹ÞXx7uúWTpç‡_8¿S±²ðý×é] y³kõ:›O 3`¿JÚ4.®j—S¥¶ðyã÷¥l°ç›S7ó7 ðXÊ’‡éZ¬9Å<çÌ݃ÂB´TæÍõ5#ð‚ž±øV‹sK6}ͼ ˜‹ôªTyæÏ¹u< ‡þYÊ©P1y³î8x&ÝÛæ€Súºì'œÍ- ϬäB†ÜmôÅ'†LºyÝH»Üàµ?ƒö×nMºª†ê®8®Yà¶=Ü7Î’÷Ïñ§Áh·6šÿƒYU²o6)­ÛlˆØô# $A ‘^wÃtsL,ð˜Šj¥9«4úþ©§ªkTÒi¦³É¸Û/ÅÂXLÇøsѧ³_~ªz4õNçe¡|pðÆ›¥ÀŸ’çÃþ!Œ˜®-…ÌñHF?yF„oî±Ü#7òv{áy—c§O/¥í¨=c'(E¥ü²MÇUÝ+5g£n+ œˆ¯]¼©ªÔ^©óE5~I­Wt¬ôzj—ÒZt6š…­­ý…ÄW671¬°Ü@áÒT` ²°à©GüÚ®t§*u"ã(¶šjÍ5ºk£]Qóõ0§' Å©-z4Öé®O¦•$í®IášØã©„qÕ#:K>"²tŽw@À½ÓƒòÖJN›1R•'fxÇÄW·ðÞƒªë—ïŽÚ<¬\6BB¢dÎUs‚rxõ|3‚­ærú/Þ¨í~Ék'«W´Sv½Ý¬µ>§‡ã<ÇO g'¿dµou{$ݯ®ÈùGÀÿ o¦Ÿá¯‚~ ø\ñö“H7€³Ë!m¨¤à“—pxçúOªÐËèJ³ŽßÒüOÌ¿·óN/ͨå´ê·ÎíÙ$•Ûù%wm]º³óƒLIµ «F솹¹•¤rª'$íÉ<Šù(^mÉîÏè\KŽœhÓÒ1I.»y½~óÜ|=f%%yÅzT£¡ñ…fäzVg¼¨»!çqyOAÓ´õ  Šê„ŸÄWmu¨`WDQäÕªu6¶ŠÀµ´by•j´tÖštci+“[F›WÎŽÞÐqÅl¢yõ*›–öƒŽ8­N•MË]:69À´P8êâ:;{HãÆµQHáIHÕD]£Š½vJ‘ äi7bã- K ¨r:#D°“Ú¡Èé…ËÚnœÖR©cºŽÍÙšIcXº§§ ¼·€ÆlÚf?„Öñ®yU²«t1®­6qŠé…NcÄÄá=“ÐÅšÍhqr˜…‚ÍerÔšº4§QÓ‘ä!Ñ úŠá«Lúœ¿fµ>Sø¥¡xÿǶ^øQaâÛÑàí.öãQ²ðüÎín· .꣺!PrÍ”®Ó#ïøŒû¢ý¼ÛþŸvßðÇõ/„¼M:ÑþËÄIµ$Ü<š»’Z}¥yn’iÙ^G;£üñ–ƒšK:Ä2VÅÐcŸ§Zùƒ÷3Ñü=¥4ùÄÑÍxÝJ²°à‚B {ÞbŠõÝÍ>N(Õ´{4ù8 TÑìÓäâ€=OH³B@t6pŒ ´±¤<|´¤- Àùh~Ë÷hYÓmå„·—Î(¼I¤@<ÌG@5xŠ[ß êvž%Ñ?w¬iS »c¹ÕYÓ´«q”unFeèhôŽÎòÏQ³´Ô4û¸n¬.£Y ¹·IѰ]pÊAÁ€,Ð@P@P@P@P@P@P@Pš|Oø£áÿ…ÚÔµVµÖäÓ´ˆ¤ -üƒÇ]±®å/&PÂ̪À·x“â'‰.¼eã ¡u¬]aQ¤@’±B„±®NI$–bÌÌÄÑ´¯¤H§ËúPakáe;?J–O õýßé@7žUC”ý(‹¿ðò|ß(ü¨Íõ¯Góü£ò .ðŽ–5{éue„,±[½Ì ¬A‚ß{¦hê è[ Ò€=§IиS²€:û}§É@vú7O’€.ÿcÿ³@ }#îP§¢|ŸsµyÆ¥¤´e¾^(‹¿Óò¬6ÐjºwÞùhÌõ};r¸Û@)â-+ýgË@8xÛBÅ+lõí@á[ ;éZ~£k{ÉÖ™²|¹˜á9Ëa}·‘ŠèËðØz¸êU+Fíh¼›ÙùÙíÙ»îxü_g.Ç`òÚÎ’R¨–ò„SçŠm®U(»ÎÚÍACX¶Ÿè'‡ü/ œ1Ç@`|Íë_¥Ò¢¢´?ˆ1ùœ«I¹3WYÖ<9áÄ+«j¶öòª«ù·JÊ[h+åˆÎyô>†®¥Jt~7oë±ËƒÂcs|=7%µöÒ½œ’Ó»íÜómGâ\™!ð߇î._÷Š.ou#„p£,Êzàì8ÇBxäž/›Jq¿¯õþGÑaø}S´±µ”vÒ:¿4Û²Mmu̾íq’çâ.£4s>¡ŒaB˜--©9?6dsÎ:ãÇZÎø‰»ÞÞ‹üîv:y6.*o¼¤ïéîò¯Âþg?aðOCûdš”Ú,êRÈÒÉwq’Y‰,ÌÇ$±$’IÉ&¹¡”ÐSöžÍso{k~ºžÖ'Ä,ÒxUúÔÕ”Tš‚Œmd£{$¬¬­eecÐí>"…T¶ ¾q]ÑÁù+W‰ÕÈé­~C„gé[Ç‘æUâ K©·‚"\bÜ~U¢Ã.Çó©=ä^‹Á@°&!íT°ç<³75ÁñŒ$~UksË7}ɇƒ ?zùSúº3þךٕäð›3ï{NGqÆi<,_CHçÕ ¬¤5ü cDôÅ º9Ü¥ñ²«x0ùeúTý\Õgdð†¨91~”¾®_ö»èÄ *Œ¿J=ˆã™·»0ï¼or’»ûÀsYKžèí¡œNžÌæ&ð+c}qX¼)éÃ>mneÜx9#,@cÚ¡áÒ:iæî[³‹Ö<oz Iÿ|O×Ö¹êaTgžÎŽÏCÍ5?†ŠC£Û«Æ{0È5Ç<‘ô˜n$jÍJÌËð…Ÿ‰¾ßk¿ÃJ-YÔ"ÍwýŸitæ0ÛŠš'eV`  1U';WP£, ¥SîÉîì¿6®zY®cCЍRÂg)Ö£MÝE΢IÚÉÚ2QºZ&Ö‰´­w§¾þÕ—÷:®›á/Œv–†|AŠíO“ý¨«ö¨¾ên`å¥RK/ȈǯƒÎg̩╿½þç·’ZŸžq†Øa/•ÊXz±qi´ÓM4Ö4õM>ŒðŸ|,¶¹I?Ñ:× l—Cê2Þ"©A¯{CãˆäšV–Ù ½ØEˆš¼•½¯ÌüŸ8ñW(ÃÉÓ¡7QݧʴVóvM>Ž7NÛì~ÌþÌ?¿àŸ5+þ¿†ž8±ñCù»þ#øçMµÕ.íp“ãkZË#[îIšö[tÞ¥<ÝÀ’ʪQ^ê¹ñsãìc;U¨â¼Õ—æÛüO¥>?ÿÁM>ü=ø[sâ/„ºí¿Œþ!j3ͧé,¶·V±Á2"3\Þ,©‹l‚TÀ\Ÿ1£ ²É%Ë ½õ«>#,öoêÓ¼c¿uÛG®½ößÐþt>&üVø“ñÇÅóx÷âÇ‹n¼Câ©-âµw + ‚8¡‰V8͵Aww9gf>jò›»?UË2ºXXrÁXãâ€W¦}%:f”PÐV‘êR¢’м‘ ÉÈï…$\Ž!éY¹Ôé$ZHý¸¬Û:£L´J–ΈREØ­óÚ¡³¢4Ñ¡±8â¦æÊí¾Ìj[53n Ž>Z››(†ä™•Jµ-ÆÒŽçcmà‰ˆ\!ü+šªfÕ¿€nŸ» {ŠW+²| .|¼Ê«•Úæ« O£uà)W;76tÎVÿÁâ Ćȧr>ÔtÆ·v]¿(ª¹“‰ÎOmΉdã$ð+£I׫K«·ü–瑜c¡”àkcªZÔâÝ›µÚZFý’ßV¬™õ×à Ãcgen$X㫦¿@„#N*Ùh!bq1u§ˆ¬ï9·&ö»níÙi¿cìi±¢D t¨Ä÷ Á>N(Ø´[ù8 ZѬSäâ€;hl¢È  x,áô  D´‡oJÙbô û,$cm~nü@ðþŸá‰¾)Ñô¨¼½>9ÒhâUbócIJ(PU.BŒp z×êyyâpTªTÞÖû›WõÓ_3øÅ<¯ ’ñ>7„V¦¤¤–‰.xFm$’J)ɨ«i–»š6#;ë^µSóü »±ßé6»¶äu¯#RÇè¹6š×;x´ðb$-yR­©÷”rÛÓÑ÷:fb8­¡_¡çb²­hâõ;mŒ@W©BwGÂæ¸nY4ŽBå ç"½ê|…{ÅÙ˜W ÖµGŸ5sÖcÊ“Žµ3FøYYØñív¿\Qõ˜ì|åã«|‰p;W‘‰Gèy%MT½Ò-/!ŽhBKŠ$BYHÈ Ž Šî•5%t|½]J2q–hÑçZß„­¤Vß tâ¹*PO¡ô8,ÖqjÒ9ð]³àˆå\ÿWG¬³™®¤x"ܶ~Ì¥‡|sMa—bjgSZs†›à˜ÎßÜŒ}+¢cÈÄçMu;›Æþã§|WLpèñ+g2n×:Û¡ÀŽ=«XRMØàÄãçó6uö~PòGå]1 x•³Vú›pøq‚ˆÆ~•\ª&J½J«Fm[ø}çŸéZ¨#Î©Š’vl؇A_ùçNV4LD¬¶4D@hÇåU¥ª1ÄB¥rÈЋHR@Œý*ÛQÕœñJ–&‘Ñ| ­åñߊÎ5¢ÝŽªùmjQRc—N^ÑʵçHãXiËbêèÙ@v ŸjÍ×IØëŽUUǘ¨úPÎ c?J~Ñ}JKFC.˜±¦LcŸjq¨¤ì*¸YR‡30îô€à•Z$–â¡)9rõ<ÏÆôé×vú†Ÿ Îñ°ŽfA¹89ë\UhCš’>›šâ²Š°©Jm$ÕÕôgο üZ~kïðçLjÖ~Ô.šm?WÛÊÓäs‚“µmÝ;×™›*ìÉüõâoVÅÕþÔÀÆõ´¢—Æ–ÒVÕÉ-,ïÍ’Õ%/ØbéqmÁÉ:ÑIJ:^I~<Éig«VKT“ûŠëKÛÃ/5üûW mÑà×Á[txOÅo‰Þø_o _Ç-î»tŒöÚ]©Pì8yÿ«Œ°Û»õÚ­µ°`òJ˜ùû¯–+vÿNïËïjè0;W3›å|°[ÉþIuvÖÚ.í]ÞþÓ?..®^×Ãކɤc RÃq+Æ™ùUœJ¡ˆ…PO8+èÕ ±Å)Ô›}lâ•ü—+·ÞýOªÿPòyE*•j9[VœR¿[.WoK¿Vyߎ¾'øãâ›g¦êvúM”v×+t’éöΰW\1Üc{g s×>÷ a(p¦*X̾¤¹å{•«6žÜ«[ŦIÃy^E^Uè9ÍÊ.6”•¬ÚeEßNö3´ˆ¿¼5‹Fñi·Œãû:ÍùÿB}+ï¡ÇùÅ%hUKþ݇ÿ"tãr‡.lFïüuå2‡Äï‹|[á‰4ø jZdÒǶÓlã*êw‘+)‘GƒÁ5ìäü[›ç¸Ÿ«b*©SIÉ®X­´Vj7½Úê´¿¡Ñü/’e¸å‰Ëðþ΢O^zG£M94÷ê¼÷Hó¿ [‡H‡aŠûj(÷s*–l÷" q^4|N2wlô}.,2ë‚>w-è–ò8®¸£çëÈìm-ÁÇÑyªM¸ãŠÚ(òëT:›H‡VñG™VGEmœV©}I›[Œ8­8§3jÖg#ŠÒ*Ç%I\Õ:qTcrÚ¥)FäѯÍÍDž†Ô£©§yÅ`ÙêÓ¦hCqÅc)ž•=ÍK{o›¥a9èzØl/¼j¥¶qÅs¹ž½<-öFÝžšX‚Wšå«^ǽÊÜÚ:ht°ÊpKcêèe QZ“E^»EdñG|2%½†É¤ÿ³Mb ©“ù“iÏË[ÇyUòkt9ûÝ< 8Zì¥ZçÎc²åìŽ'QµÚGêQ©sàó<'+Øæç·ÆIÛ\ùŠô951gŒr1Ån6lâµ»µÉ^+*‘;°uµGËÞ3³º°Ôí5[&òï-%Yb“hm޹N ò^6Ѝœd´z«pÆgS8V¥+J-I>Í;­ôß¹úu£|:Òµí'K×t•óô­FÚ+»iü¶O6):6ÖŒ«‚çšüÒptäá-Ö‡ööOFè»ÂiI>é«§®»w>lý > ]è¾0²³•-õ M¥ä†A°L°§YLãåýØèOÍ&ÇŸhQa#â€=kF‹îq@«£Å÷x WÑâû”êš‘ðöŸ'€=£KÒ£© PM™(f 6!é@³¢öü¨þÏŠ€2õ-2"‡ŽÔæš¶—ÍÅy¦©§F›°(Íu[$ù¸ 4Õ¬Óæâ€<{ÄV óñ@ âm:7ITŽ ÐÈž<Ò"F•€äÚ€>ŠÑ>+x§Æ¾ Ó´ë}-¬µH’}bÞì‰&hÎÕQF]“8€®;×Þa3*øÜ:N6zk}]·vIZìþLâ. ʸg9©(×ö‘NOÙ¸{°RÖr”¤ç˽–¶w½Òê|/ðÝ•Y Gm½k¶ŽÊìùœËˆ9åÉv{áU(ö®ØÓŒQóq•ª½Ž²×à 1ûºè4xõq²»M·‡&?Ò´åQÔãöòªì8ôl„ý*c+³j´`™¥Œ§Œ~UÑ™ãÖœài&Æ+^TŽ?m9=A¤«3nN3éSžæ•¦â•‹Ù1Š*ùQÍí§Ô¯.ž¨>è©–†ô¹ª2ìg+Dcp«S•è:M4.^M) G-Y"鉷 £4ÔQ¬ï¡IôKe8¥Èh±:¥Ñ”ç RéšG×S&ëJXÁÊóQ(X륉r9étðÎß/“Îø×²2.´`A;+9S:©c<ÎZûGT•¬eLõ(âÛÑuþ–¬¬¥z×<¡sס‰iÜógF*\®*”Ï¥Áã/mO+×¼4·PIˆþpã\Uhó#ê09²š×BÏÿÚ+â/ÀÝ*oé‰cªxM®<ÑeªÅ$ÇOÜNónVDÚ˜1BJ–¥›Šxüv8àœy¾Ï:n7ù4ìþvÞÏTûs~Ë8²~Ú²p­ksE¥Ím¹´w²Ñ5ªZ;¤’ú3Zøñ{ÇV:6§£k¶5ŒÐùé&§FßlŽEVBâèJF#nÓóçŒ~-™øÕžR­,4ã S¦Üd£êš|Ғѧ·ã¡ù —‡òšÕhâh:“NÍNr÷\[M/fá{½ïͲµµ¿u¦|X¿m×¾9¹”ûéöù@+ÈŸŒ¹Ô·¨¿ðÿ‘éÒÄä4¥ƒKþß«ÿËoQøkâ½b) Õú¾(Û4~çìZ,sŠõ½¹Åu¢t  pðq@‰÷hÔPçÇÆóñwŇÞÛÿI¢¯ÓømÂu/Ÿþ”Ïá_¥n2Ç/ú÷ÿ¦iÒm÷5êâ'cà²|73Mž¥£ÚýÎ+ÀÄÔ?ZÉ0›ƒ¦!S޵ãJ§¼~“KjKBݰòÛŽEmNzž~3 ¹溴;q^ÞZ–ç4-6p×Ñœ õ©HüÿK]næ3È®”®x•%c“ÕcÌmDÖƒÃËÞ<‡^‡â¸*£ê°2ØùëÆÐnÎ;ò±(ý%¤cð¥¤~ðÔ°H’Æ,!BѰ`P+ Žáv Šô(EJŒìÍ*Ê–aˆŒÕŸ<·ìÛiü֫ȇWÒƒDØZU!¡xLU¥¹ÎÚi¾R¼VQ¦zqvÔÝ´ÑÌgéZÆ™ÃWí¹èz7†£”)á]TèÜð1y‹S¼ƒÃ ¨Gøâ®qQV9ð•¥V|Ì×Óü3óÿ«®{rÚG®äªÊ¥Ù?Àê×BT@¢>k¯Ú«Xùç—Ôçæè$~—ÌV6ߥc)G•Ýž•*5ÕhÊ0vFì^àŸ¥g O"³:ñ9#ÄTæŠÐÐAÚòV5qÌôð9;¡M¦Eð÷š¨Þ_QéXCìî®zxžúÚŒ’è\ƒÃEX/ô¢xë«\¬? òIK”ÖooF_/‘\±Ær»žõ^ö´ÜyHáÛÿ,ÿJÓë÷êq.·Ù$—FÙå.ÎqJ8«ÜÒ®GìùcÊT›A-³“íW _Kœuøu_›”żÑY¸+Àí]T±I;#•MУ&ޱG–JÕb9ô8%“¬2æ±ÆêvîÀ®¨lxX¦ùšgâxcÆzTš?Š´h5 5ÿåœÀ†Sꮤ2ž:©®¦–"<•ctsà³lnM]bp\&º¯Õ;§èÓ;K ém~ø„j77-ÈÔ.n,£µžýìÌ‘Íp†Ø«3@ÒÆ¤ˆxãn+áÕ”fxŒ^ì$í¿ÂõŽúü-wõ{ŸÑ´¡K7ÀÑÌ(¤£R*VO™Eµ¬oÕÅÞ/­Óº? ¼Iâ­{Vñ®áõBvžL*™<"î$„Q…PI¨«Ç§%J*ÙÔ¦¨ÁS†ÈÆûÿtUûf_·b‹þè¤ê‹Û±ß`_AùRöÌ^Ýž[ñ)¼££ié*þñžWˆc<`)=ÀåÇ¿>•ú7‡ôyå_(íËõ¶·r]ºE¾«NçÓðâæöµšÚÉ?½µùLŸÃ1Gß×ë4WC<Îw»=·Kˆƒ×¥|f*W»=JŒeF+ªùüTBÓãû¼W\óø‰’t®ˆ£Ç¬Î¶Î.•¼QåU‘ÐZ'JÚ'ŸVGQiÀ­¢6¬µ7íãéÅh‘Å9PÄ­,rÉÝ–ÑqI•–Qj:aÂ'#Š†ÎšpÔÙ·‡ dW,ä{˜jHÚ‚ß§Í9žîm[[e‡Ë9žî vt–# •É®:•O£ÁàîÑÓÙÙŽ8® •O¬Á`Vš6ª¸ô®)T¹ôÔ0‰Xº!t¬¹ÎåAò¾(çe}Y2¥Íªí< Ö”ê;œx¬$\YÆê6Ê7W§FløŒÏ s€Õ-Ôôìk×ÃÍŸœæØh³‹¿P¡€è+Ô¢î|.c“HçfPs]‘>jª±¬FØš*- +Lùׯ6‰*O¸ àוˆÑ÷ÙEWÔ¿Ù_S¿Ö¾ü:»ÕgYžÉdòÕ1 ½ÌÐB¸PËQ®z¹$’Iü×3‚§‹¨£ßóWgöçâjbø{ R«»åkå8¥§d’üõ8ïÛü5ðèø¨ ÿÒkšà>´ø“CŒm¥zÎù(Õ´hÇÉÍz¾ù9 WÑã_—¥užHõ òGµJ£´Î<—Íyžµ°‡æ€>~ñ¼4rŽEzwìÙwuà½zÆ{Ÿ6×MÖ¦·µb¯“Cår'2M#däüøÎèj( € ( € ( € ( € ( € ( € ( €>wý§¼I}¡ü2}&ÆÿÂOxº$óe“o$RÉ6U•ƒŽ„”6àÀ¨ÈÎ>ÐàŽHNx ª|1¤Â#RS  Cµ°·ù(v;+p£ä  >É÷(3R±âÆÊòMwN‡çù(â/‹Ò¬ßô-YíkÝ ùÞg—fݸãoÙ³œœïè1È{àû\$|Pо¶ÿWÇ¥{ Œ·N(V% àд=(j(ïÝJàuXƒ"€<ËVƒïq@_«Á÷¸ 2Õ¢ûÜP’x†ŠðAþ³ŠùOÇÖŸëøõ ­?f¯†ãWøcáiáÊL×_1vÜÊ¿û-~…ÃôâðTå/?ÍŸÇ^/bëljñT¨ëðé¸WÛø-aUD‡{W­‰¨¢½ÝÏò\JÕ9ªît6¾عò¿Jã…^f‘ôxœ£MÊÅåðß”så×­N¤RÔüû„«*ÅhL4oö+:µÌ¿SFÿf°§3ÖÆaì‹K¦wšëK;[æöÖûµ§µ8Þ^Ö© [8ƒG´H_R”·lÂö£Ú\ —¡NkLö§~fB¥ì¢Èã´ Î+N{lr,;–¬Üg$QÍq:N:˜±Ú©3S"hò:U\Ï’Åfƒ9ÏJô3o,ÃqÅ)FåÒ«f`gåÏËYò®½‘Å’*œIÄp¬Û8ÍJÈÜW<â{jÖ8‹Ë˜ñ\ò‰íQ­¡Çk:bËæ¹ê@õðx–)ÕlÂîx®Äúœ-kžâ½L— ³(ÙãÔòëÓÜû̯Ò‹¹ôçì…{k®xw]ðôáµá®m q–²”‚vw¾Ù¼ÂÌGËçF3Èù›Åž© ÎÚb”š»÷㦽áÊ’O^Y;nßÊqþIœðü?sŠöÍŠö¹Åzî‹Üâ€:¯'Ú€EŽEYNú(óßâ-ÌúÅÜ\ؽ¤‹t!Kœ²F‹ÉÈ:¢¸öaÉêUÈ`©à)(Êú_ïmµònß#øŬULof+RtÚšõPŒaj–“ŒT×KIYµ«ÖÑ£'JÛÏ7#¤´=_E‰IJùìL·?`Èè§cºš0°&=+Ê‹¼™ú j\´RG/z®úI3ä±Óœ/fq:˜ÞI#½JšÇÝœmäj3ÆkÓ§&|>6”UÎRðœ-zÙòÔ—CÔÆQªç±Í‡ÑžC¯¨ùë‚©õx±à^0Lg¶kËÄ-»Ê$Ô‘ì ­Ðü7ðûddµÏþ”K^†³Gçù³äxª£þÚ¬¿Áÿ¤Dèï­b!#µ”QçЩ# HTžGZÍE“«&t6°™"µŠGz²±éš5´h«·5Ò•–‡‰&ªOßg ØÃx{×-Y5¹îàhÂM(êz‘£ZË´¢CÎ+̯‰”V›w•ä´kÏß~û;K_Ù oÛ^mLmN‡Úá8g¾+‘hZJ½€'Ú¹%‹¬ö=ú\?–A.f[þÁÒÇOÐV\¬v¾Ë–ßÇÑ´´R[îQT±5žÆsÈòøFòØ·o¦iÞZì#me:õo©Ù†Ê°<‹‘è\]>Äý+'Z¡Ý·º’Em§otV‡ZR[&kK ç”SÔ”ÚYúŠŸi3W‚”çƒOB¡€Ý×éZÂU^Ç#‚¦×2Ô˸‚ÛŸ—ñ­á9žF+‡ìs×QÚƒ¼ší¦æÏ›ÅÓÃ-,r:¨RÞ•èáÛê|fo´ùO=¼Q¹ò+ئô?5ÆGÞfå#^HWTO¦¥$±·>>êƒFi©G©ÜEv.„ßÚ4È`3íùXx œgìûñóäÿ<ø¡V…|΢‡Å$ýlßäÖß™ý9ÀJ”8B›ÄOšþÑÅY.XÝû¾w—4®õ÷­²GägË_‹êk¨|´Ç¨Ÿ/¥¨|¾”§…üJ x£M8ãì±ÿèǯØ<>ÿ‘mOúøÿô˜oËý†§øŸäŸ ñ¤O°Á×V¹±Ø¹eLöécDËw¸áj];Çͱ0¸ 2î3éSÉ}–)GY3'QÔŒ]4(ßsÆÌó%dÎ*ûQÎFêôéQ>™Þúœn¥u»û×§BˆÍ1|ç|áƒz×¥IXøŒ|Ô®sÒ°®ÈŸ9WS–Ö.@FLñŠSzaawsçOÞˆ–ažÆ¼¬L¬~’ÑsiŸ±¿ tý7À¿¼á61]i:m½µÏözí†K€ƒÎ‘xRwÊ]Ë $òM~[‰«íëN§v÷íÐþñÉpÙyvÒNœ"Ÿ.ÎI{Íh·wwµÝîõ<öÁÕlî~øz;yw8×à${}žæ±=3âÝl¤|ЬèÓ}ÞhÕ´y¾ï4êš<ÿsšõm»ÍvñJЊ(  wͶÙèÈu»’ ‚hçïÞ|’ŒôôìÿcöO…Ú-ÄšgØîï®.î¦-”÷9¸‘c•¸·B°ícœ Lb€=¢€ ( € ( € ( € ( € ( € ( € ( ‘jNûwï$06—y=Ýü²2±‘&bŽ0§8 Vêl‚ $.ÁÈ;à‹,CÇ¥}?áÛM¶ùÇjéÒ"‡8  8þè ÐïõtæÚÌaÃqÍ~zx·X‡ÄŸ¼W%­Í•Í–’Ñi1Odâ@Z Zdv1'’hØ m)´ÀÒM=Š”%i+=É«¯½j¼lð•®#JdŸAxvßý_ë¶Ðbí@|Ÿj³ s@Ð@¯~çá@F¡Þ€8 R ÁŽ(Ìux>ÿåÚ¼?{Šòm~•ø  ñë8 ˜|{k‘1Ç­~©þÈÞ1þÎÿMËÛ4’Çy6`¸Že ÷“º‚ÈÄ À2“¹`¬¤®Ëq.–õüÙüíÆù-¼»é´"ºúhú­V‡ÒCÂÖãº~b»%ŠrV>n†CN„ÔâÑ$š¨Q·4R¬Ö£Ì2øÔ÷o¡›.“9+]qÄÈùÚ¹5.è¢úT ðËZ{w%fq¬²]4FtøÔqœj4E|fîÊ’Z Î¶ŒÛ<ê¸XÇ¡M­”çZ©³ŠxX²&·UÇãT¦ÙŒ°ÑŠ*4(xU©3Žtbö+< Z)3’¦%f@À¢lå8¥¡IÔt­ÃR%vQV™Í(¢i˜J6+¶*ÑÏ$ˆXzU#¡BX•AÚ)5b£&÷1n@“Ò³gU=NVùc95ŒJƒgzˆ79®y#Ø£&q:®Í¬­\ó=¬-î™å:ÊÅ—®–>£å¡ã~%ä>G5çÖ±öo=ѹû,Yø¦óöð%¿ƒ‚Í)ÖãÏû:éžfò»ão•¿äûG‘º¾+‹(á+åó†+m-µùºZÿ;Û^[ŸqB…:ÜÇùWä_Ù˜%ö‘Ÿö>^¾Òxãþ^ò¡eØ/æöV\¾ÒûíÂÿß4Ö¾Ðÿ³2Õö…þÇðØÿ–ëø-?©`PþÏËÚý—á‘ÿ-‡ýò(ú¦uÔ²Åöý¢l|9ìýñÑá—3¯ƒµ¢ƒï}Šl~µÑ„Ãàcˆ¦àõæVõ¹ìpþ-†mƒp~÷µ§o^ucùfµ#寭¨_`ÚÐÝ„ô®IAA£F#Ò°‘êRf„g¥e#ѦËjk&vÀЈÔ3® Єô¨:bÍ›G GDYØXJ8¨7‹;m>PvÔ³Tzç†/× ‡ÔnoЯØ­ Ï2½6Ï\Ñ5háš!@#5Ó ÛSÅÄᜓG³éº¤-wBhù!„£ÇòìÛÀ÷­U±ÇO/•Ó<‡Äš¥³ù™À® µõy~JÇÏž)º¶òæpÙÀ¯2´Ï¹Ëðî6¹óGˆîÃy„ã5È¡z+)$â/èó*)„±³8c´øí?•}/Î*U!ÕÙý׿æÄ—Ð&'JöÍa„ `Ñgû™ ]Ñ'ÆÊìUƒ(ÔP@|ñrM¿üV=í¿ôš*ýC†ÿä]KþÞÿÒ™ü%ãRÿŒÏÿë×þ™¦.‘8y®ìL7>S%Ä(Ùu=_F›…9æ¾ö’¾‰žˆ²,Öé“Ú¼VœdÏÒãR5èE³"îB»ç8ÓNr½‡¤¢äÏ6ÕßçJöðËCòÜæ¥äÎöb¹¯Z”n~{®ãs˜º”œç¥wAXùlLÝFrZ¡ùÒœö'µ<_a‡5ÃTúœ ØùÿÆOˆñ¯/±÷¹•×FƒgÎæY¬#tÙçú†¨>bßË¡òu¥íSosÇ<ã94›,¬ É­êsGeeu_2i" ’Ë0<õË™æ4²Ì-LMiZ1M·½’WnË]»yK<Û¡ov:¿E©ô§ZÁðçLðF»´°É¥ J+2Éü{n °Úß;4‡w KÁ5ü‹œç‹2ÅÖÄݵ9I«ïfôOW²²ßM‘ýKK …†ž‘JÖþ»ŸŽß<3ª|<ñ^«á}^9[ÈÆÚæD/-÷Ê# @NÒ žTãSЍ¹¢gJ­hjŽ/ûI?¼*ý‹4ú»ì'ö’ÿ|Qì}Y‰ý¤¿ßýƒÕ™å_&ŠY´[…Uó@3É¡ŸA“ùšý'ÃþxÇÝ“‹K¥ß5ßÎÊþ‹±õ; F5`Þš~¿ð Lªñ_©Òg>aÓ=³O”2ÆÀõèÁŸˆ›Lî´¹~dæº`Ïé¶ •C]±gÍ×Z³®³” s[ÅžMh¶uVstæ·‹<º°:;GéÍmyÕQÒZÈÖ±gV&õ¼¹Åj™Å8›¶²dšÑ3ŽjƘ8 ”ɱô¤Ñ¬gbÌn+6Žºs¹¡ íïÅc%sÒ¡S”ÓŽàqÍa(­,I«üšçœ[ˆÒçCgršã©NçÒà±j:¶oC¨š¸åDú*9š]MÔÔÍbè”3UmÉ®á©,5Íuʬ™ Õrr\Õ}_ÈÅæ÷Ý™Zާ»7jè£@ñó,×›©ËOvX’Mz§cä±Ç'vÌ+»É&ºéÀùìn&÷mœÅÍÈ$àñ]±—ÄWöCy‡'5ª8&®yî·|©¼³~…IXõ0t\¬‘ä^§kÿ #ÂóÝÉ*[ÙÝ Ó$D †,È›‰2*)õÝ€A ×Ìg˜e†·z}ÿð.~íá^Qõìë ÌŸ,;k§"º¾ŽÉÉE?[&›G×Mñ²ÐËü÷دÏÏëÓæ‰¿n¾ ëºe­Èoé®Z6ŽF+s)#¡ÛÊ©ÁêÄ]l¢s@µ£Í÷9 UÑæûœÐªhó}ÞhÔôy±³šî!Ÿ§4­Àðhͪ6Ûc@â9v—9 ™üy©$Q]Hî"–$ž€PÝ´íKHð‚4fßìú½–gowõ*d…×r’§ È$ph¯ € ( € ( € ( € ( € ( € ( € (â/ÚNÇR·øá=ZïPß¡ÞifÞÒÇÎsäÏ ÌÓÉ呵w¬öÃp9o/« ÏK—oØPÓ~’&¶ÔÒm_JwJ(?Qm±gµy¶«0ù¨ó¦÷MÒ¼9ñ7â‘¥¡Yõ 7íÏ›v‹u/@<ÉŸñŒ’rJI-Š”å7y;½É+/¹h¼¡¼)pž\|ÔÉ=ÿ÷ û¾{¤Šð§®(Ö¥P@÷íµö P›ïP ¨M÷¹ :ÕåÎêòÝ^_¿@Iâ ~Væ€<#ÄS¬æ€>cñíÆ£4úUû$x„Ú~Ï^€?ÜmCõ¿¹?Ö¾ë%Â{\9zþlþRñ3ˆž‰ñt/·'ãNõ>“ƒÄm)Üdãë^œðJ:Xø|?º¯™ËBôšØeÁ|þ5’ÂØô*gÊkVfK«uùø­£‡<ºÙÇ™WÅÛ%ª¥JÆT±î£»e£tå«5Lëx¯2¤—±Œå«XÒl㫎‚Ý”^õ;bµT™Á<|:ÓÞî8¶…#ÌÄcù´L¬.}ëNC‘bHå¸Èq…Œêân’+´µj'4ª•ÝÇz´ŽZ•R¹j´ŽyMe“Õ¤sTô*‡ïVa&çñªFOR…ÌÉ9<úT¶iN.L䯮÷1ü¢°”N+#š»Ÿåny¬¤ÏF•=NNúáQNO5„™êЦÛ<çU¼Ë?ù£UÃ(eû>AÃ×óÇŠZ©ãc”Ñ—ðí)ÿ‰¯ujºEÞé´ù¬õ‰çñ_G/­º‹Ö 9zµt¶é}OšÛ£îcãÉ¿çäþuùcâ ÿ1òŠ'üÃŽæÿŸƒùÔ¼þÌCâ‰ÿ9ñÔßóò:—ŸËù‰|Q?æ#>9—þ~OçRóù1ë<ÿ˜añÌßóòqõ¥ý½/æ%ñ4ÿ˜ä¼w¨¿¼ã>¨mS^Ò®ôÃu³Íòð¼[ödnÆüã#8ÆGZÛ Ä¯ ˆ§]ê£$í{^Îö¾»ÙO<¯0Ãã¥ïªS„ùokòÉJ׳µíkÙÛ³?amw§Ý\X_ÚÍmk#C=µÂä†E$2:žUyWô7<+AT¦Ô£%tÓºiìÓêŸsý)Êqtq”)ס58I'E¦¤šºi­kTÖlkÄØ®i#êhÊÆ”MÒ°’=JR4#=+•)«6ŽØH»t¬Ù×hFàT3ª,Õ¶”n¨fñgKkpÞ¡£¢,ëôËäb85-FG¢è÷¾TˆêÜR5Lõ½'\ÍRv1•7&zn«–\îäóÖ¯œæ–ìõ/Ä"“°ï]ªxØœ®Èìm¼NIÇÖºcÈ©–_¡v_“o3¿­S¬c·[Xóm{Ä,åÀÖ¹*Õ»>‹€QI´y¿ª!‘wrO5É)\÷èÒåÔðŸ^¢+–p#Y3ïõ êšuÒɵ!¹Fé÷³òÿìÕìäu=ž-FßkõýÌüSÁýk‡åWšÞÊpž×½ß%·Óã½õÚÝn¾Åðßúž}+íæcêmõ|еè3ðœÐ°h³ýÎhÖôIþæ wpÍÓšÑV (ÔP@žß_þ.ÿ‹ý«oý&Š¿NáÇÿ Ô¾úS?…¼iøËÿëßþ™¦C¥>ÆRO½Šêèüç)Ÿ³šg¬hÓ«ƒ_=ŠŽ§ìYkÅý½Æ µxó‡¼~†Ä¥FÍ”îîU£u 3ZÓƒNç7A¤Ï8Õ¤›šö°ñ?0Îj¤ÙÀ^¹f>•ëÓVGçxÙ:’g9rÝk¡3ÇœN[T|DÔæôÚGë¯Ã× Sê°+cçßɈŸèkÊĽ¾É£ï#×¼9s¯„<5´i`ÊÆ¡Af@ÌxîX’OrI®ú2Q£»#ä³r«˜â%7wÏ-û&Ò_%¢ò2µ ISq-øTJgM 3z#™:¾ùr[XûMOOê–ŽÆ”:òÄGï?ZµVÇ4ð.}¦ÇÄ‘±Re϶kEQKs†XIÑ¿*;­?ÅËÐ?é§V1ØñqX*µä΢P¿­oí»\²Þ]ѱˆÃ™üjÕKœ³Â8½ 8¼AÆŸ­'f8óAY—¢ÖrdúÕ¤Œg)1j«ÚAùÓpLˆâ'M–´ÃùŸ­%M,lØñ©àñ'ëC¤‡uDNurT ÿ­G°Fï5¨Õ€jØèÿ­?`fu:뎪T1¨xh·s¢9ÕXÅ¢»kýþj½„NwšUz€Öˆà?4{‚ͪ£žÔ5WmĵSŠZ#×YsKsÍ|Eã-+F·–çQ¿Š(”g–?Jç©V•äÏkÄ㤩уmž/à(nþ&øþßÇZ®|¡»9¦ÚVòðªÊŒ§rEó6ðWªm$«…þ|ñoŽ(Ò¢òl-KÕ¹íöa½›MYËM5¼ºJQoõ—`þ­ßÔ·7xÇ}]ôrí¯»{Úêÿ]Ë«?– ?A_ϲÅË—r玗.ŒñωÞðÇÄë;Ko%ÊÏg¿ì·–s˜ä·ÞP¾Ðr‡pAÜ­œ`óYPÎ+à¤åNÍ=ÓÙþ¿s1ÃçØŒ¾nT¬ÓÝ5£ÞÝŸ^ø‡ö_ñ…‘¶ñ–“Þwö”2Ùy}6íÙçnÏÍœíÆ\ñô8·ïõŠ2nV¥~÷¿-¿‘õ~9Ëß3ÅPœv·+R¿{ß’Ý;ß˯øƒàoÄßiwڽΡáÙ­í#2È–÷“ïØ9b7B£“×8dàW«”çùVoŽ¥€§Ï T’ŠrŠå»Ñ'Ë)=]–Ö»ÖÊíwàøÏ$Æâ!†„*©IÙ^1µÞËI·«Óo[-L/ ü0ñ§Š×:v»á¸Ûû—7W qëÄ¿Z¥áÖ*ª¼jÃï—ÿ"wcø‹-Ë¥ËV•_UÛÿKC5‚~.¼‹â›?‰¼(úŸƒ,Ω{`——>|¶ÂÝfó`S.Ë9#kà6#7­“p^/,ÅN²­r/™&îãkéx÷·U¶º=v¡Å˜ $ðuU¼˜©*q—,9TœùyfùïuÌ´wŽ×jIxç‡ï•<¯犕-§ÇÑ÷™ïÏ™s’+Ó¥+£á±ÔùfÏDÓ&Г]pgÏâ`Úg¥i÷`Æ •Ù9^•™ÔZ\r9­¢Ï2­3¨³¹éÍoyu©M­Ò0y­£#Ì«I›ö÷#ŽkTΔÍË{®F5¢‘ÃR‘¿m|ŠWqæµR8ªQlÞŽàJ Åi{œŽ.;–Õ²3šv"äªø©jæ©ÊZYªN¨W,¤äw¨q:¡]¢ôW¬ƒ¥c*Iž…| ¬Íõù«E•<ÎK©q57ë7A´óY.¥±«2¨Éýk?«¦ÎÅœÊ1ÔaÖHïúÓú±;k¨Ïí–'­?«"?·Ø­qªHǵ’GM*¨ÓhñŸkðÛE4³Jrk‚µT•Ùõ¹fU$£©çÿ¾ü_¾ýŸ5OÚ'A½ºÓ£Ó§'@û†æ÷G!¾‰Ñ˜„VvvWG“L$Ú?Ág˜å^~Æ;-_¯oëô?­<,áYå8g™Wº•EËÞ.Ï›¾­i¶Šú©&¾ðÏuD¢êµÔàýä–f* â¼õÃèß êÙÔô‡uLª ß­zþ¨ýÏš€=SHÔx_š€=#JÕÊ•¨Ô4kîüôÛA­tùèZg§Í@[ÚÏúÐg^ÿn€0õþå—A@âŸlYO™ëÞ€9/ƒÚøûâ\WsÚ7†¼½Fç Ó–?fNXeÑäÈ ¤[”a‡÷ÕP@P@P@P@P@P@P@|¡ûWÛih>×'ƒ:¼zÃiÖóïa²)­å–EÛ§&Ò#’ x#' ïƒA4õ†/3\ö þ à   TPn¦3y.´Å šøkâ½³éÿ-õ²Š=SM7ìSsq Œ®X˜²Æöãq6€~\Eð…ÞR1šúÃ×_sŸJö6ãt)ÍoG `=hZ(  íGý_á@oª±RÄPŸê}îhÎõi¾÷4漿šò/ËÃó@â)¿Ös@,xúçýw>´õ'ìÁñ6Þ?†úO‡P:6—sso)“1yZ|¯=12ŽqÈ>Äþ‹Ãx¸<iÛX¶¿þ§ñ—œ=ˆ‡WÆ9{µ£ F×Ñ(ªvzox7¥ôk[Ý/¯í|R„)YSÓšúFã#ñHFµk›ÄÊTÿ­bÔQèÂue»ˆ üP’c©)G©¯·Ó/S:W6¡qve§Ö77u¬áFîÇ^#3Té¹\®ú™'ïWZ¢‘àK2”ÙÛË£Ù¤CÅÍîÀÜg«Urç/¢¨AÕ’ºŠ¾›¿%æö^gÖ~ø™áO hz_‡´›ø¢Óì!XcE-Ž®Ûp ±Ë1ÀË1=ëù3ʱùÆ2®?êTm½ô¾É^îÉYE_D’è~YáÌÃ4ÅTÆb Üæî÷ù%{»%¢WÑ$'øã¡Žº¼Cë"ÿq.Ä¿ùvþãp^-íIýÌ®ÿ´×Yƒñ•Æ´\)‰òíýÌÑpN1íIý̬ßü:2N·oøÌ¿ãV¸Kÿ>ßÜÍc_üºs+¿íá¡×^µünüj×bßüºs-p9ÿË—÷?ò5âüIà ÇÕH®åáön¿æ§þ/ò9£Âr{Xªß-ÆNfÿ¾MRðû7ó ?ü_äj¸F~GçGÅÓhÿüM¨éö¦ NU¾@\±w‘A•ù$ŒÍæœqŒðÅ~·’aqX<²†\¶qåvM¨éevÊÿ{½Ïî/±•*ðÆ…yóT¢7¥¬¢ýÅ¢IÚŸ"¾·êÜ®q°¾pk²Hýš„ï©©t®y#Ö£#B6¬Z=*s-£Vm°‘r7ÅfÑÙ ÿ*†Ž˜È¿ Ø Ô4tÆF´W]2jZ6ŒkkÓ+RѲ‘ÚØk¡€üÔ´j¤u–^#xÈ+!ëScU3Ñt_˜Yˆ>†‘jHïí~!Äv°ÇÖÚ£ nÛˆñŒdÀÕ)´c,59¯ñ*o´š«Ú3©EJç©ü@‰÷þU¹º¦ã±ç:¯’@ÃÌ"‹¤ÑäÚæ¶×¬@s³ùБ2‘ÀÞÌ ¶0Ì9úŽGë]x:žÆ¼*7dš¿§_Àð8‹ó«…Œå8IE;|V|»èš•š}Õ­þjÐÜÚØÎ“WE9­~‚Ÿ^øví"!‡A@ݠܯÉóP¯è·iò|â€=kF»O“çßÁtœ|€5aºN>a@ ;0ÅûmÎZé‡5ÙŸ9YÄ箘s[Æç•YÄä5yŒŒÑ7¡8ey\ñív_¿ÍpÕgÖ`c±óÇîP$ƒ<^N%Ÿ d´Ûhè¤ñÑ´7My‘çµ¶Ž(r¹Uãò­]_gÈóã—ýsR²VR“~z»žW®|D·ˆ¶n”(êÄñøz×LZ]O¨Ápüåotòûß‹ÖPÊcŠyçU$W±ñOF}5©8ÞJÄ–?ÅÓdÈBö%¿úÔãæ&¿ û5±ÚY|@Î10ýk¢8£Æ¯[¡ÚéÞ:•Êâàcë]0ľçˆÉ#²w6¾5 /ï†~µÓAâUÉ–º%ŸXíZÖ8ƒÎ­“%Ðê-|^ÛFd¼q™W)WØÙƒÅãŒÉúÖŠ¹Ç<§ÈÚ·ñrç%óøÖ‘®qÔÊ™¢ž-SÈ|­_·9ÞT×Bä~)ˆÝ'ëOÛ<¶Kd^>)¶ÀÄ™?Z¯lŒ³gØQ☿½úÓöÈO-™`ø¶Ò8òÄçëOÛE²Ê²z×7ˆqÜú“Y¼BèuÃ&›øŒ{¿ˆKgÈeMÀt5œ±\ªç],Ö’V<êOx›ÅS¼V!³fêl„ÆpvcïƒÀÀ㌊üÏ|QÊøJI{\F¶§®Ÿ-Óž¾ä]Ö­94ïÉ'o¡ŽO‚Ë"¥Y^]–û_^ËoÑ2œ 4MJT»ñ…ÔúíÚȲ¬s;CmV$ ¶T2È\6Þ€+ù¿‰|cÏóÉJ8F°ÔšjÑ÷¥ªIÞm]4îâà Õ÷m&w¬5°±pËâ¨Å¦®¬äî­ñ5£ZÙÅE«îÚLö=.k}>ÞÚÊέì­Ñb†P"DŠ0ªª8¦+ò猩V¤ªÕ“”¤Ûm»¶Þ­¶õmõosÈŽ2¤ª9Ô“rní½[ovßvo6§Æ3Úº~´w}sÌ̹¾È'usÔ­sš­~c’¾¿Á<Õ§ÍÏ}¯jáU—wjß C™ÜéÁá¹¥sàôñhø{ã­KHŠá†Ÿžm¶ìŒBÜ€2I!rSvy*{ñ_ØüÄ3ÌòÚëI{KZZ«ÝhÛI+s|V¶—KmOÜÿ±ªgÙE½-{és‚—çØ¼/$ʰò©‰¤œù#å §&“מ->[{üüªÿ)ó¶öÞñ­¤Gª[ÞYA3$7öîÂò¸*Ì£ràã'ƒÈ¯"hº’…*ŠIuM?M›Üý—æ1ÁÐÄc°•(Jjüµ!(´ôæ^ôbß+vº]žÍ ëkØÛ§½z4ªXøÌv ÏTzž›|³’6ãëÒ»¡+ì|¾&ƒƒ³=G¿ùÑXðx®ªr< e Gu þ^ ¯s¢ÒõPØ ÜV°¨pbp§Pš„`d0?n¤5Е˩{ (;±íMI3'Ji“¥Ìg£ z1ZQ-$ òj\McRÛ“ x©å5öº—€häL!ÇbÌSœîféÐTJŽªX†ÝäË/s• ž+5 N©â¯6R3ŸZÕ@àx‡Ü–9öõ<ÔÊ76§ˆåê6[®¹ŠðÖ«þ¯æ kÑõ¹óPªèúÝù¨Ь/þïÍ@Þ—«2Ëq@œ×Ož€5àÖz|ÿ­M.·þÝP}{nNÿÖ€9 WĹûÏÖ€<#ž žyÒÒ9n.æuŠ+{t2I4Œp¨ˆ2Y‰ 9$€(ôáWÃë_†þµÑ‹ê·,/59ÄÍ*KxÈ‹!Œ¸ŒTP~TbÌ@="€ ( € ( € ( € ( € ( € ( € ( €8o‰^“Ç>ñ…àŸÉ¼¼„5¼†O-|øÝeˆ;mb#2"†Â“´¶9Å| ào< ÖwvòÛÞ@æ9m®ch¤‰Ôá‘ѰU F }KáOBB)#ž:Ъ[k‘ñÈüèj=n2¨þÞ‹Ú€)_kQ<$dP•kº’üý(ãÿ˳xW]ÌæK+©-[Ë#rYøãçŠ% eñÉ#¼|¤D7΀>ˆðõâüŸ8üèÚ´‹µ0¼~tÓÁr¼|€5c}á@y±ÿ|Py±ÿ|P}ü‘˜¸q@m«ÈŸ7Ì(̵Y‘wa¨Í5k•ù¾jó-Zå~nhÈ|Ev˜š€<Ä—±¨”–àf€>Iñö©f¹9 høMðëÆº/‚ôïiæÞqª~4ó(ŽUW!SiÉF%I2YHÜW^~ç'Àס…Eö½ëzí嵟NÇò¿‰U•æ¹ý\$î½îùìÜ[Ü®¬¤­7(h¤Ÿ*’vz{¿Ä{ ã±ñŸ}§Í¹‘æ"B§ ±º0©#‘ê+×X·Kݨš?8©ÃÐÇ'W8ÍhÝžªû]n½™Üéÿ´ÛôÔaéœÈ×Lq0žÌñëd˜œ6’‰ÔZøÆÏßεhžm\º¿c¡·ñ}“ûñùÖʬN ™}tïcZ?Û²îYÆ®5"¶9*àëNÑ‘(ñE¹ãv¯l™’˪"xüMb3îiª¨™`*=Ë£_”6F>µ^Ñ<“°¿ÛÑŒ)ûDSš®D{Š^ÑÕd9µdÛ¸‘O êò½ŠRk–éÕÇáRê$kÙ/‰ Sò‘š‡Y#¢9|ÞäOâ èp£ÚÜkgksk㜿ëYº§L0,ƹñHé@üjTŽÊy|žÈÇ›Äp²±WɬÝduÃ.’z£™½ñ*ŒáëV=*9kìqz—‹`„6ù€>™æ¹ç]#ØÃe2žÈáî¼i…¶¸ÇÖ¹¥‰LöédÎ;£Î¼Aã8-ÑÚIÀnËžMqÕÄ%¹ô8 šuQFׂ~ |Yø¶mo­láð„ûûoYVŒKòÛu¼?~lÇ&ôl,M´1M*8LN2Î*ÑîÿNÿ—™¦cÄ9' 'Óö••ýÈëg®’–ѳVkY+§ÊÏЇŸ þüÓ$ƒÂÚi—UÈ'×µ·÷ì¬ci•W‘â5 ¿ b côX\º–]+¾ïsñ¬ÿŒó —%IrÃKF7QVV½®îõz¶Þ¶½¬’xÆZ#´·*¿ï6+ªucM.«ŠžÍŸ0x×âÞ•k寃°…5äâ1ЊÜý&á\EWBÇÂ?þ+jž!–{m:c©Î]OZüç:â¥wG îÿ›¢ôïù/=Qý¡á—€U8f9ô8§¥6šœ’½ù¯g{tæ’½¹W,Ÿ€\Á$®òÊKÈÇ%›’kâç‰i¹Íݳúk’áòÜ40¸Zj଒éþmîÛÕ»·vÎ~úÁ&\:gê+zUœvg•ËãYZHìm~&xÓO²‚Óí—-íÝÆí#ŽÛ˜8ÉÇÆN9Éɯ¡¥ÄˆÅE¤íÕïùŸŽcü!ÊkÖxJPæwå”W§ºÚ]m²ÙYY/¿¿a övøõâ=Cþ"j>ñÔ7ÖM£xh^C§YxŠ6‘Qà[©7<³I+¤gŒÅ(R'”—ò;Vo:ÊÑÑŸ3Sü.]QÊ¥çŠÉYyµ¾Uºí¡úaûLÿÁ2~|Vð/…ô¯ƒÙÞño†ëÚÜIj׉® †ñýË1¹`³"ys—ÉåU‰ÁP¼8˜x­­®¤Òf€™Onãúרe8¥ZŠ¥'ïGO—Oòü÷?œ|BÈ¥—fRÇR‹ö5ïÑMüJ÷z·ï-–­EZ,ûßÁÚèšÆþEzÇçç¿h:·Üù¨ÖôÍPŒ€=?FÖþî^€=ÛYÊ©ÝÚ€6!Õú|ô¢º¿Ë÷¨&Ö±ÁzaÖ¿Û Î}~ó|fàýí^ðÿäg¯Õ²·þÉGü1ü‘þñå?øÈs'ÿOêÿéÉî“r hI¯VKš'ÀR©ìªÙ•­×ËÖ¸ªS>§ ‹ÐÙ‚ùŒ7•Í:W=¼>=Óz2;«­ÙÁ§NŒñxÎmŒæëÍuÂ'Îâ+˜W2ç5ÓžZͳáø,zV–±ÊÛ“±Âë7?5…Fz˜JgŽø‚ä*Ès\YõØ whùwÇšÜ:xkÛ­†Ú¥ó ¸n'=€ÉÇ|b¼L]UMsKd~ŸÃù}L\• )¹ËD’m·mK[·¢=—ö6ð÷ìÿûLxÖOxçâÕ¯‰¢ži,~Ão%”šå¼+­/ÛXmeek„kh¶Ï¶'”2ª¯™Ägгp þ×õä~ã“øWS-§Fk•4í¯V¯¿—F½äî—îoþ|(øjö÷øuáíQ†Étïí+ >$¼šÜl;%¹Ç›.LhÌ]س(f$ó^dêΧÆî}Ö†Á$°ôÔt¶‹_›ÝüÎ;Æß²çìëñß\‹Åü%qs¬Nn¯µ+M6;뉌¢VÞ@pìã,Â@[,!ˆ*5g˜ê`pÕ¯ÏMkåg÷­O‡|yÿ™øI«›¯†ß|Ká[éïZ#RŽ-bÎÚÝ·Ÿ"ÿs0ÚJy'íBymã¢8¹Çty8ŽÃÕø$×â¿OÌø/â¿ìûLü&¼Õn´? 7޼!m‡‹Vð©ó®$¦1F¯`OÚ<í»Ö%•?úÆ ävRÆÅîì|Þ;†kÂîæ^_å¿ÝSå¬êZ&£}£k6—6:½„ïkwcyC5¬ÈÅ^9#`]XT€Aï†"úÜù,VRâÜe4uV^-<~óõ®˜×<:ÙO‘×Ùx°§Íýk¢5Ï&¶UäuVÞ/m yß­n±—S(WØÙ·ñaÿžß­h«œu2¯#~ÛÆW™?#Z¬AÁS(»ØÐOÓOÖ©b %”y¡ñ‚äfL­RÄO(}3øÍ2q'ëOëG&}†(ë'Z>²?ìFúº§Ä[h#Ú÷(œg.ÀTO’ÜéÂðôêJê7<êoНss%®›sçJ½v¯Ê:Lò8Í|þgÅ8 ¦ßZ¬¢ßK6úëd›¶›ÚÝ7>†.©ÁT¯/Çîßð6ô­FïQ”K¬Ý‰#Wmá?#öò2yíÓŽr+ñŽ-ñK¢ð¹<](É5)ËI«ÿ%¤ÔtûZ½tåi7ÅŠÃÓÃÇ— ;n÷ùŸÝmÏXÓuhbŽ(¢ ‘ ¨£@èì+ð<]:•êJ­Y9NM¶Û»mêÛoVÛݳå±YI¹KVÎÂÛYR£&¼¹áÚg“S Ó5"ÖŽEdè3†dÏ­¯÷… „a¤Q¹×•Pü®iIšC )3‹ÕmøŸñjËÃ6Nìâ[ù²°[!¤oèy=½Éý¶Cõ1Õµ¢·}¿®ˆýk€¼=Æq^5P¢¹iÆÎskH¯Õ¿³¯²M¯„5mKRñ&§>«ªÌeº”ÿÀQ{*ŽÀ‰9$šýkB–’£EZ+ñó~g÷ ð¾ ‡°PÀ`!Ëýò}e'Õ¿¹+$’I/Uð¤¶ú凼7¨‰¦ŠÆ{™ä…Ý„rÆÉÄ2;”‰>€€:œ}VVžo Xzéºtܯ½ÔTUï{ÇÞôV]O͸ò¤|;Äã³|ªP†/*Qs§Ë*’­>WMÇ’ªTÕ›¼çÏ?ùvLÓþiŽèÒ™bÿžnÀúü{xNÃajª°œôé}­’vò¿©ùoxñg˜ åøŒ>)}¥M¹E÷<ç+6¹¹n“|­;5ÍjÞñ/†õ±e¦iZ¦£¤ÅY•pTœt¯­zU0Õ(Ï–)µ÷Ÿ…ÎðYŽÚש ui§%õºMÞÖ{÷¹» ø†ÚÉÕnn‰¸=ñïZR¬£»8qÙ|ë&áOEµñ=› ’Êá¥O#ðí]‘­Œùú¹eDíV6:{ Iœ7Ôò+hâ:3̯“rëuVšüdYr o§—WÖè¿ÿ ]µ³iAaدn¢aý•:ŠÉ-ÄK…™”cŒf¶Ž.,ó«pýZnö7müMpñN ŸCZªË¡ÃS-’V’5Ï‹¢QóÈ*ýº9S'²æ·Ž!>§™_%œÜNª×ÅÛ$£ëšÙVG—S,’WHØ_ÂGîåèkOjŽG—Én‰"ñ!Çï?Z[²þe±ª|X¡B†ÕûcŸû1€ñFOúÊ=°ž]ä\ƒÅH E5U2KbY¼UÝB3êMª@°5ì¨|N3÷Å/lWö{ÿ R*’XqG¶ìù_CçÅ-!$ÉØT:×:!—[¡‘7‰•zÊÔÔ:ÇL2æúF³ã{UfhÜ穉]Ïk’Í«ØäôÍ[ÄÞ5Ö#ð×|=}­ëóRËNˆÊê†DÌýØâ,a¥r¨›fQÍy¸œÆž<Óv>Ï$àÌfoYQÃSr~š/6öKÍŸ¥ÿ¿do x þÏÆ>>¼‡Å>·š+«Iv Æ>Ö€5âñ|ÏÖ€#—ÄŸôÓõ  CÅb5#Ìçë@šî¯â ZÇÞ´–ÿ^¿“Ê·´ƒ–vÁ'“€%‰@$4ögÁ_€ßð€ÝOâ¯]Zjž7v’;fµ,öúd'+û¢ê¥¥uûÒV1¨{Jô•P@P@P@P@P@P@P@PÀ¿´Ÿƒm| âǺ%¤š>¿3Á}c_íš_3òZd1Ø€n݉i9ÀðçˆÉXeIzÞ€=ŸOñ.øÐ—æ€:K‚?ÖPe×°s¿õ  ëŸ~ìþóõ #T×ÖE`_õ ñŸÙ5½3PÒ¯I6×1”,–CÕ]r ¤S޵y?„5Ù¬®î4Ë©ƒ]ÙKäÈÜ ü¯€N7)VÆxÎ;PÒººvÅ"¿€=£@ñàª_¯½wPk=>zׇYéóЯ¬c£Ð_ÛíÐ[hûÔÄêº`Ä5y†¯¨}<ÏVÔ>÷Í@c«ê?Í@-â=SýgÍ@´Åè|n×A˜ãëT±70žJ©½ŒëϬ@—¸ =ÍD±êtÑʶ‰†°øCûzüOÒŽùF'/u8f±ÄÂï•ÎrUü­ÎRå—ò;¨Þêz58}·ªü{±Õ4Óy¤jÖw–†òîìäYðH;]IÇq_m,Ò!ÍNI®èþa¥Àµð˜Ÿe‹¥*sV¼dšjêêé¤ÕÓOÐøçÇŸä»–{k ê`pJ6O»~=³ïŠù߉pøv¤¯'Ñoþ_fDxuà†oÅ?¼ÂÒP¥g9»E;7n²ok¨§nh·dÓ>mÕµÍWX•¥½ºbü³LªÃ¿ãšü×0Ïñyƒq”¹aÙ~¯w¦ý<íÎð“‡x>0©J—¶Ä+?iQ&ÓVw„~ZJñi9«Û˜ ¤g5ã¦~‹8²´‹Z&rÔ…ÊB­ÚµŒš<êÔTº“Y†Î+¢5lyU°JF5Þœ€k¦cÂÆe©­UÏÒ?„¿ðUoڃᶙ¡øwÅK øûE±ž-߈à–=RK4XÐÀ·º©r±±ÏÒo‘™Ìƒ ^Œ1®§Èbxn ·ãùþÐÿ´ßÂßÛÏTð]‡ˆ|1iðâ–pšn“â_RMCE¿µ‰’Zí-c¸´HQ •Rx•®'óD(í:Tå G“0ÃPÄdÉ·ïAî–é÷]=~^‡Ï¿cÿÚCöw‚ïUø‘ðêèxBå„x§G‘5 =‘%H’Y$ˆ–¶IZX¼±r±;—À]Á”rÖÂJ*ö=쿈(×’‡6¾z?ëÒçζ÷ˆx-\¤ÏªÃcc³fŒw “Ç­c(,R¾¥øçëÅbàzñ =ËBCY¸‘¯Ø´“‚:Ô8PÄ&‰’|w©q6tº“­Ç¡©q7rÂÜúš—hÖ--×½O)¢¬\†øŽ7Rp5Ž ßïÒä®êl¬óŠ9F«š ª>Â<ÃùÒä4öêÅ uÄÿ57\®oÚ§ÊG¶ š÷+Öš‰¯tf¼ÅŽI­NYT¹>Ÿ©Ë¦_[_@Ø’ ÇqÜWV³ÃVE·_Oëñ<"Ë)ç™u\­ÌÕâßI-ììº;+ò¶–çÞ?«Ð5`Dd7È=—HÔ÷"üÔèv¤ARšô -d˜Ôæ€7`Ö:|ô¦š¿Ë÷è´š¿ûTMõ¢ üÿ­|jníµmJßQ¹ûF¡ ̱ÜO¼¿› r·7'$“ÉÍ~±‚œ*Q„é«E¤Ò쬟K…Äa3 N>z°œÔ¥vù¤¤ÔÞ®ï[½_SÕô{È{W«t|&<²¹ØÛOÆ3YÎf¾†’Üíy¬.zÅr¡Zãp94(XrÅs-LÙåëÍmž^"©‘1Ýô­Ò±æJfüÁAô¥&iF7w<×Y¸á¹®JŒú 3Æ‘V§wMÝ}ß×à~³ü7ø£ðïâÿ…í|gðÇÆ:_‰<7>Õûf—8“È‘£I|™“ïÃ0Ic- dMÀ2ƒÅt©)+£Å©Nt¥Ë5fw´È9øÁ^>Ó ÑüwàýÄzD‹¨¬uí>èc˜+(‘RUeÜ8fÍ5'S3©J—-H¦¼ÕÏ|wÿåý—¼hngÓ|1ªxGS¸¾ké¯<+©IýÛËB°N&·Š-ÎH¢M»TªåNðÅU‡[žV# Àâ>Ç+òþšü™¼[ÿ¥EŸ[»øuñªâ Qm7Iñ’³¹˜F0“ÞC"(?:ÛŠÃår¹n˜f2_<\OÑ©wJ¥»&¿_øÏ&ÿ‚t~ÕÓ ¾Ò¡ð¯Šn^u‰´ýX1Í•becy¼{P¤-—R7ÓÊ}ÁX˜«Ã–^Iÿ"ñOìÇûRøû7ûwàŸ‰n>Ûæyئ··fÜùŸbi¼¯¾1¿nì6ÜíltC0§/´xøŽÆÒµé7~ÚþW<»ÅZoćßÙÃÇÞñ†N¡æ}“þ.ãOûW—·—æ¢ïÛ½3Œãz種ˆbã/…Üòq=^‡ñi¸ßºhçcñ¤‘à ë>"Õá€ÜÉc¡XÍ}4p†U22D¬Á:ØÆX⇋Œäì*\?_.ZTÜŸ’oò;û/ƒ¿´N©¨Øiv¼|—7“¥¼owáûËXU‚ƒ$ÒÆ±Æ™<»²ªŒ– kf’¿2;ép†:mGØK^é¯ÅžçáØ[ö¬ñ¡=–©ám#ÃVé •oõÝjÞHd`Ê`ZäÜC \!Ë€p–kI+§sÖ¡ÀÚ²´â »¶¿KŸ¢Ÿ¿`ƒ¿Œ:¯âÿ„ÿÅ »÷Úå²­„YóWä±ÜÈÙŽDÎi~xç–xe|­m‹úê}ÖSÁÙ~X”¦½¤û½ºí¾ûꮬ|¡ûOÁ:|DÞ*Ô>!~ÍvzyÓ5g¾ð$· f`¹iÓÝñÂÁÞF†GŒGå°Œ²ºCÄçÆIÕ£ñ=Z}ÿ®æß Çz˜T“í·ÝÓå÷v?7¿´u j÷>ñn‘¨èž#³Ùö/Xµ’Òæ è®»â\£« Àô"¿6ÇåhÉÆQ±ù.g‘V¡'Á¦z™âˆW÷ÀŸ­|Õ|“Øù NY$ö;K?C´~ø~uæUÀ˱ãVË¥}ˆüGüösK.Ç$²év'‰ &aŠqÀ˱QË§Øæõ/ZD¬Ïpzí¡–NODz|ž¤Ý”O¼sñÏDÓÌöš|Ï}¨ ¨ŠßPò>gè9#’3Ò¾Ó*áLEkNªåw¿ÉKÌý{„|'ͳ§ µ!쨻{Òê´øc»ÑÝ="íncäûíCRñ¥6«ªLeº”þ½•G`?úýI5ú*4°T•*ÉWgö? ðÎ!ÁÇ,#÷Éõ”ŸVÿÉ$’IiZÚtȬ*T?BÂ`ºžµðÏKóõy.ŠðƒË_ÏŸå_¡ðÆÒÃFRÞZýû~ Ç^9çÑÇçuhÒiÆŠTÓI­cw+ߪœ¤®¬šJ×ÝýÝá½ &µ…Ú<œc÷”i]É™Ž5£Ižeá´lºãDùêÙ‹]M[¿éšµŒÖ„6rº ˆÖDlFTðp@?…\°Ñ©Y+£–Žu_ UU£7-šm>Û¯#ç?ˆ³ŽŸ}2jœèWÊûœÚÄZ)WcË ¡HÀ9\u9œ'”FOš“å~[}Çèyˆ•¨EÑÆÇÛFÚ]ÚIßù¬Ûß­úY¤¬üÄþ ñ_‚íží¥•´ %E1:rJ|ÙQÇ9Ï=03_9›O•Ru¡OÚAogf»»Y躻ü¬›?iðÿü}†Y‰Æ¼"£j ÓS§'§,Tý¤œ›j1påvIMÎJ'“j><Öà‚k„•£†2BIàgŽE|„¸·Z¢(§¦·zú«~GôM/£ÞC—a*V̱5*Ê7•à¡Ê•íË%RïG¯2Z¥ek¿1³øÉã¹G¸–í¿Ž ódŽCH8£“kÖYÎ"-7f»ŸËÃLž­7 |Ñ—Ii¦¥’jîïg¢I­OB°ø¥k2%ÃO=¼ßÅ ÜãœÔgèxè+²Ý ^o•öÕþGÍb¼.Íc7N…8ÕI'Õî¤ÓNÚ»]k»:ø~2 x¶Û]JÎF +oõ‹ ¤ÿþGŸÿk=¯+¼*·øéÿòAoñ›WŽT&y®-úgÁã98n=@É g§JÍq>/ZŸƒÿ#©øÖ£„I÷S§ùsÚß$üίOø«e©anK+ŸI[(zô q×5­&ÁW¨é¹ò¾ïDþ}>vò¹ÃšxÄùV8µ†UbïxÁóN:¤¯{Þ÷^ÍÎÉ7.S­°ø‰n ê‘3¨ÎPkÔ¡šaë>ZUc'äÓ>4à<Û.¦«c°5iA»':sо®×i+Ù7môeöø™>r/ŽGL5týq÷¤V«2áúÉÚÅy>&éË÷e'þIãbi¬÷EQñ6ÞFÛ¹jŸ®'±£á¹Å^B]üFŠ$•CÏ4¥‹Ht¸zS{MÿÅ«5•íΩ ̽c2¨#ê3\òÇÆö¹íPáJŽ*~ÍÛ½™ê þ|`øÉ>š|áMB]ü3§ˆ/"{}5cI„2?ÚXlrŽÇ1Æ^C±ö£llqWÍiQ^ôµìµשô¹W攣ì(5ö¥îÇ{^ï{uå»ò>ðø}ûxnÆæO⯋n^Ö_ʽاm|åg³÷oÕa|7øEð×á™>•ðëÂ:4ûMÄ[¦¹¼ÃHëçÜÈZY¶™dÛæ;m Up8¯"¥YÖ|Ówgèx,¿ —SöXZjòþ®ÏG¬ÎÀ € òÿŒ_|ñ×Àz¯ÃψzWÛ4KÌIñ—}‚#¹¶ƒåÊ›Ž!™23+~üWý€>?|’]WÁð7Äo&ßôŸÚ²ê0çÊ_Þéû™Û2Hày 6&wòÇó§…ü}e mÏ=Áê(Ýô_Z¸B³çñ RÓ*ƒßPÆñ}º.<ÿÖ€2oáý¿ª1·²ÈóÈø-/Ï!ò•ö¶m4úðoà~…ðŽÒöu½:ÇŠï‹-η4òwea‰77–œ)o˜—a’pPÛ¨ € ( € ( € ( € ( € ( € ( € ( € Äñ‡4Ohz—†üG§E}¢ßÇåOm.@aA ee`]Hee ¤ ~x|XøO­üºÎ‘{}¬|>q2_]ìk>c…ÿHت¥¾ìŠª2vÂà։ㅕ÷ÙR8 ÐskâΟ½ýhìž'gÌýh*çĹSûÏÖ€8ÝCÄyúЙë~&ûÿ?ë@9yâ˜íÂJ)YÓS—$žº¶ïRú¯†ih´Þî_x¡:jò~(Ÿá[­xïîýÏüÏ5øÂíUÿÀ£ÿÈí~"ø²ÖEj@v¼kÏåZÒâÜddœã¾kñ»ü?ôwáªô% 5Z°›Ù·%®·ŠŒo¥íï+=uÙîKñ{ÄrÆU¡ûÑü‰5èÓã.gj”¬¼ÿ;~gÇbþJ„T°XÕRWÚqpV×[ÅÏ]´åîïÑæŠ>"zGoûiÿÖ¬WTÿŸ_ù7ÿjzú8á:c¿ò—ÿu/[übñ%®<½øôó¸þU¤xÊ¢ÿ—_ù7ÿjrUú6`êoÿÊ?ýÔ/>/ê×(ŒÖìf9Ü ˜UôÇþ•sâûÅZ“¿]tò³¶¿rùœ¸£š§Z¤gЦ­ÊÕ6äô÷¹£Ì”lôV”îµ|»Gâ—‰Fp–Øú7ÿY­µ?ç×ãÿô_Ñë¿æ9ÿàµÿÉ·Å/‚%‰Hô\ÿ:?ÖÊŸóïñÿ€/ø—ì Ñãÿ¸ý¹GPø‘âmF3× ŸõÈÏÖ³©Åç”~º}Þž~~GfÀŒ§ ^3–"R…µ\©JöÖÒm¤¹µIÅÙ{·oÞ9F×5rIûcþB¼×c[ožß%þGÚCÃ>§ÁáyšI]Îw~nÒJïÉ%Ù"‰Ôµ?ú\ÿßÖÿçXìOüý—þÿÌöŸ dŸôGÿÃÿ‘)LóO#K4$­ÕäbIüMc:’©.i»¾ìôpø*8*J†š„ÑŠI+»»%¦îþ¤ JfŽ …£Ïjµ#SLáö«R9çBå9 `ŠÒ38ªáÓVe­7Z×t%–3P™,¤Üd³27“! Jp=xÇN+¥b*:~Î5%ýÖÑâ<£ZÆUÂR­4­ûÊqž›­ÕÕžªÍkäÝú;[3ì¼±’È‘„€äðÇ3^=\¾¤¯5>fõwßõßÌýÆ8J1Ž®Ò„m¨ÙÅ%¦ÉFÊ*ÖQOM–šôšž¨‡ûÒHëÕ9VÇààã‘ÏJ⫇©Gã©ÀæØ,Êë UI®š§Ó[;;jµµ¯¡e—5šg\ãr».*“9å«Ç“Z&qÔ§r»CV¤sNÊR[óÒµS8ja®Êï8ÅZ‘Í:2nlLáG=t³‰ãbrèÔÙ¥eûC~Ñ^Ò´í Cø÷ñNÑtûxí,ì,œmko‰Z[»2_ÉF•æXÙe8·‘ŽÂ¥F˪8¹Á]-ÏS ƘJu©áqP©7h§Õúùì¯k½ÙñôZ¢2ø¯6Xv}¥Ú -M(ïÁÁÝšÆTOR–a~¥ä¼_ZÅÓ;éãSêYK q†¨tθbÓÙ“­Ï½CÑW™`]{Ô{3¡bÉëÞ“¦j±dËuއšžCUŠLwÚ³ÔÒä+ë(_µZ9 úÊî<]—!_X]Æ‘ÜÓä%âPÏ´Š|„¼Rn)¨¼N„ qïT a,I]®=êÔyâNÓÁ_.ü%z¤gÓ²ñƒÊ´¿á^¦,;äŸÃùÀþ½~Šø~–mŠÃÙW_tÒèü×GòzYÇïÏ|D·Ô­m¤Ší^7PQÁàŠúÓWGä„©ÉÂjÍhÓè} ø«!“õ¦Iê:ˆ~ïï8úÐocâ ¨ÿZ߇^éóþ´¨šÿË÷è uî¿?ë@—:þüÿ­|e ë7Òê7í«ÉXÜÈ.ÇËþ»yß÷~_½žœzWê öPö •½:Â\Y…Å,~!ãWï¹åÏ·ÅwͶ›ßm;h{Þr³Á¯j“?2ÆÓµÑÝÆär jÕÏ>œÜI„ÍšžDmíä;Ï4rÛ²'·^”Ò±•JŽ[™÷3CÏÍTôFQ‹“8}Nóïs\ó‘ëáéo¬]‚šä©#è0” ñލ‘G'ÍÐóq²>ã(Ã9I›¼@|MâK˨œ5”¸€ƒÊ Ë~'$LWä9æaõì\œ_¹êþo¯kè·…Ü!þªðõ*u£lEoÞTº³M¯vé5Ë^.ö›™À¼uä©:EG†µR9'D«%¾{ ÑL㩇¿CwÂ>4ñ×íRã\øyãM{ÂúÔöíi.¡áÝJ}>y fW14²±BÈŒTœeö´*¸ìÏ/—ª´â™÷·Âø*‡íKðÓû?Mñn¥¥üBðÔc ñ-·—{´9Y+Ø6;M*{•¸mÊ®A%ÃõC%¾§‡ˆÈiKX{¯úþ´±úð‹þ Ûû4øÓCšãâ—ö¯ÃÛã̰ºµ¹Öm®7<€}žâÖvÚ‰?› 8iB¯˜µtÇ o¡âWÊ1Ÿº¹‘÷‡ÃŸþ0}’?†?|-âKùìTþÌÒõ8d½‚Ù¶|óZnó¡Á–5e‘‘˜+ÜVªJ[3Ï©F¥/Ž-¹TdP@P@p_~)|;ø?á{¯üNñ–—á¿ A¹~ÙªN#óäXÞ_&ûóLR) Ãii ¤ñIµv\)ʣ傻?•?Û;öÃñOíqñ'NÕ¬leоø`ÜAá(íH’”ÜÜȤæyDQåŒqªª.ã¾Y|ÌUHTVšMyŸQÈ)â#ÉZ wÞé5ÑÛ^—Iú¤ú#æÛ?·ÝˆF¡}qsåçgÚ%i6çÆOå^_gNþÊ*7ì¬~“Ã|5‚Ë.ðÔ!+_–*7µí{%{]ÚýÙÖÙÏuhöòÛ]MÐ)X¤Ê´jrHR:¹ºzŸZójBRŠiï¦þ¿r>Ê®E–âèUÃbpЩN«Nq”#%6”RrM5&”b“wk–6ÙbxãÆ1Gpë’lE Ç’«É>çšàyNM·Kñæ~‰ð3qUg]åÉ96ÚS«vï¤c5®ÑŠI-H—QøÓ<rZ6Ÿs/‰Zxc·¶ƒo‘4Edó¤yKn•„P#†W—O, 7Áp,S¼'è­úÝ~GóÇø'‚áÌDåõïÜûÍsA]+è›RJNÎ×QW{G[,{ã?É Õo4#/mk”~¼’O=Î=²3_¡ä¼'„À5QBó]^¶ý.»Ÿ©“dªtòúw]'=dý4J*ëOwŸ{ÊÍÄîᎌð(’97u;[Œžø û×ÖË.£8òÊ7G…CŒs,5gV…WZ×M§ek+¦´VV^K±Q>hö¡”[<¬NC;‘o—ô®™£nTõõkðM#ê0ž,qFœiÑÆZ+¼a'½õ”ã)?›Ñh´yáKk]2âCX-‘æzŒ ž{ð;žÂ•L* ”©û±»ë=oÇ¢ì‹Áx¥ÄÔóIcéc_¶ª£uýÕÈâà¬Ûi¨¦œ¤÷”¯Ö|%°Ýrc™$׫–Ñ(FZ-¢>³*ØìM\N"W©6å'¢¼¤ÛnÊÉ]¾‰#ïoX«A‘_U‡Ž‡à9½v¦ÙìX`0œw5ß%_g¹¼ºbࢵä8ž!õ*]éHÑ•xÁÔTÊÍ)bšwLò¿x*Úú)vF2AãÅ[ ¤¨Ës™Ð’»?+¿iO'€% f±Ãkª¹ …t#—ÚJch8àoÁÀ*äyçÃ.ÇÆ½•9]Û´¼—E­Õ¯g¦ŠÇú%á_Œž2á:¹Vc9TÆRq´³÷©=œæ®¥Rñp—7+œZ—¿%QŸ$AÈ5çMŸa‡¦ïs¡µ^•ÇQŸI„¬n@¹ÅrMŸA‡‰µ`W,™îÐ…‘~1Y3Ѧ‹ÑŽ•“;©¢êÀÛÄ×]Ó†þWkZÏUoGt|öeÀœ9]ã04Üœ¹œ¢¹$äïvåY;Ý·vÓz½R,(`‰÷oý¿˜ÿÏßÂ?äy_ñø5ïÿÊ•ù2u»¿v­ì¸õ$gùWwúÕŽ_f?sÿ3æ%à ÉÝÕ­ÿSÿåc õúüÉy&ÿRsWOŠñJIÔ„Zòºünÿ#“àA:2ŽV5:9rN+]o7¥×ĬõÖÖv ñ³lC-Ðaîø×bâù¯ùsÿ“ö§ÎÕú:aæ¿äaÿ”¿û¡¥/ŽõÏ-cŽEP:䓚UxÃ+{*iw»oò·ê<ÑË&¢æó dê^ܼ‘;o{ó{KßK[–Úï}2ÿá1×÷ö¾½±Åcþµã»GîæzOÀÛÚVÿÀ¡ÿÊËQ|Gñ% ù »ûº7ôa[C‹1«ìÇîü‘çâ>œ/-«WÿÀ©ÿò£—Ö|eâm`¸¼Õf¶áäB|´ÚÝT÷†8ù³úšãÄgXìS¼ê´µÑhµé¦ÿ;ŸG”xcÂÙ pø(NVåQ{I7µï]E½ß"Šo¥’K[áwÄýKá7‹¡ñm—…<)â…X%·—Bñ¾‘­arŽ-á‘Õ‚²¼lŽ6í$£:4PÌ1åw6ý[:3>Éñ”ù}ã§ù~gõ#û!þÕþý¬þê¾,Ó4?øG¼I£_µ†«á¹u¯dµÈß ÊêšP®ñÇ™"™aæö(ÖU£t~s™å³Ë+{9;§³µ¿¯¿±õ}ly¡@P@á?fïƒßìˆ~‚}f8 6ž"±ÿFÔ¬@YByw ó2#M#ˆdß r£lP熿ÿ¿ñ6“³wð÷ãU½ìþym7Jñ”Öê!2 $÷ÈùuˆŸmÀv_º² &µûþÓ~Ó­¯4ë_x¢åçXžÃ@Õ¼¹bR¬L¬oÝ6¡H[.0¤n ŠÔþþÒ¾Ô|=¥ê¼G%Ö³7ÙíŸLò5bmȹ¸šÞGŽÙ3"üó2.á€]ð¿ì§ûJë—òÙjž±ðåºBe[íkV¶’)2­3î!‰É@¸S–€zÎû |J¾ëâïˆú’gÙŽm>¥æçvÿ3Ìû>Ìa1ùÉÎÜ €}=ðãöJøKà{ kºD^0×&‡Ë¹¾ñ$ q ecÞ"µ`bEÞ…”°y;)‘ §è € ( € ( € ( € ( € ( € ( € ( € ( €+^ÙYêVwzv£i ÖŸuC=µÄbHæVGSÊA ƒÁ€>#ñoìkki·_ 2øi©A¢üCðÅö‡.|“vEs…Fo&d&9v‰vÆm¥°Ø!Cµ¿x?:ãu?ˆª±óó ñ'Åkt‘Úeõ4è? fOÚö…{WOÑ?áøuåÉÿ G‰#xEÄ ä¶û;oõ·¢›Ìð>Æ_9M}ñöfñ'ÀŸèž ð牵/húUš®¿sy$öî£/u ÿ_U%Þ™ä]ïáïGul³ Øõ RÓ|PB™?Zé ñOÞ~´¨¾ Ü¿õ  Òk½~z̹×~SóÐ-{®uùÿZã5={ ß=y®­¯ý¸ŠËÄšUî•}$be·Ô­ÞÚFŒ’p \« ã¨>•l¶¾\•©¸¾Í5ùž¦_Æ™^sAâ2ü]:ÐNÍÂqšNÉÙ¸·­švßUÜõï|q´Ð´*îúê[Ä!¤–2@I!@ó–LýÎ? 2x–ùÖêÛù®›zk{-å^-ð޶gJ9-8ý^zÆN_ ÕÜe§6Dí/uÇšMó5ÆøóâWˆ¾"Ëi M¶‘m†‹NŽBê$Æ »`onHàX·ÍçålÎIKH-—ŸwÝþKn­þ×áÏ…ÙwRœé~óSITjÏ–÷PŠ»åŽÍëyI^NÊ1¸\qÍ|ü§sõú8eF8ñXJG§J‘`/åQs¥D-+š(‹·Þ‹i_jâ4¨§r\Ù)¦e(”«¹ƒ€Ò”\—6J«™J~^j¹ŒýÄ0Š9„è´uI˜N™ Žªæ.˜GjËb6\Õ&g8܈ÄMW1‹¥r&B)§s)Sh®éžµ¢g5Jw 0gÒ­Læ• •Þdšµ#ž¥hÑ-±VW‰Š:ÊÊpTö ÖÑ՞ǙW ã%:m©-S[¦¶ie§‹Z8Ò-JÕÙÕpf‡9ÿtã{þžuL¹6Ý)iÙÿ™ö8>3•(*xúM´µ”m«ÿ ²Zog¾É'§G§ê6º´M-«©ÃFü2úd{ÿž†¸«QžÚgÓ幞8¦êaÞÛ§ºíu®£W_4Ò¼a>••Î÷Ha„žÔùˆtYCíT¤e*$Ml¦©NÆ2¦gÏ\àVÐÏ;‡åØÇ¸€0 ×L'cÃÄáÔÕ™ôWìµñgãOÀÏk¾&øWâFÒìõk)tûû[ˆVâÚøìuŠS ü¦XÌ‘ÈG ¹hä–6ú|£SûǤ??ë¹øgˆ|I„É¿Ù)5,Gþ»¿7Ò=µzZþßq}â?ø›Zñǵ{_ÅZÄÿh¼ÔnÈ/3àEPª¨ **ª¨ e†ÃÆœl‘üÓfõqµêJí›ãÀžצŽïYðî›{* f½´Žf !A`N2Iǹ®·ƒ£]óU‚oÍ&|ý>$̲È:8,UJqnö„å}¯dÒ½’×ɶ½û3x]ó¦ÒVïB¿5ÃØI¾‘ùRð¾@E#„ŒÇÁ##Œpâ¸k‰»ŠpzíÝù>‹²±õ™¼M‘¸Â´Ö"šåVš÷¹VéJ6|Ò[Êjné>÷ò_~Ê^6Ò¬cºð¦µkâ …Ï›g$BÂCÊå–vFà±;™0Äâ¼_V„y°óS}­gòÖß{_3õ~úH帚Ζq†–=&¤êGfß2QR[$¹c;·¯*W<Âoÿ-4Û^O‡ú‘µ·‘£d¢šbVO,í…Èë¸d2©~pJüÕäO†óÁÍÑm.Öo{lßÉm®ÚŸ¡á|kàúø¨ác˜Â3’M9sF:Ç›YÊ*vÑ©I5/q®tóïn´û«› FÞKkëi)­îÇ$2)Ã+©ä0 ‚ Šñªa% 8É4Öèý3Ä4q4¡Z”Ôá4œdši¦®škFšÕ5£DãQRsûzñÍW&KônŽ*]¡˜Â[2Â^§v¨t™Õ |{’ÅþýO²f’ÆÇ¸‚ðzÑ성Éõ&[µ#ï —LÞÄúŒkÅÅT©¶g²6ü?¢øÆ7/gá}çP™?Ö4@,pä1äb2±¸Œ‘“]˜\³‹—-(7ýu{/™óyÿå<=AVÌ1¦ž×Ýê“劼¥k«ò§dî쫼ðÛÅžÓn'Ÿ]Šòü°q¦Û©¨²FÁ,ÃaU‚]Ãëipõ\=œï.‹§Þûú-~óùë0ñ‹›æqÃ8Pz9·ï½›Œn­tìäÚ³V·+úþ3kvŽÛPcÀèýï¡èzö¯>µ ˜wËR6>Ç.ͰY½?k‚ª¦ºÛu¾éÙ«ÙÚé_u¡îz/‹a‘P}¡:ÄôODÓüKËûáùÐOˆ“ß΀4ÓÄI·ýpüè )(kò„Ïô Pd-ªR0•6ÈŒU\ÆN‰ Cšµ#žtn@ÖõJfÃ=¾{U©œÓÃ\¬Ö™Ï¢¨sOr«ØƒÚ­U9*`è}ðçö»ý©~ý–?üpñM½…¥‚évºf©t5k+;eÙ±!´»ÃÑ*² ePT¬AÞ8™.§™_$£Sx~Ÿ‘öo…ÿà°¿´Æÿݯ‰üà-O²ûñ—ĉߎ—ÿ 'âGмXtß3ì_ð’ëZØü;g•ç;lÝåÇ»n3±sœ åfÖ§µ‡Ë)ÁûªÆ%œ!0â«+î}NЧd‘ÖY z×SSì°2PHé ‘JdŽEqÉj}‰Æì†âè"¶Q…Ù–#¡ÎçÁÞ]BÚÛY½Œ¬× È ÚHŒŸ—v )ç×ð¯Ô2,±RÂÂr^ôµù=¿ 3øGÅ~8©˜gøœ5Þ'È–©sGI6ŸU'(Ý%t—«÷­'@†Ö$ŠF=_­}4)(«#ðüV>Udå7vtÙ€'̵¯!Áõ–Þ… lc•Œg×)Ƽ¥»9­nÏívÖ[ö}¢‹~3·r‘œwëYT4ZîzX*Þʬ*Úü­?¹Üæ>j¡– fo˜p+ ú—ámy£ô7áÚ´í#ƒŽ+ê𚟀qP¹ô•µ„I¼â½eÏ¥RS“Ô¼¶` „â‹¢•95vV¸´Ç4nÓg-}§ã’5cjç’=zR/GY3Чf^гgt ÑãŠÍp,ñëÍF§B°œS°Â­´ˆ ¤e4Š’VŽI•Ž+DrÏB£“ÍZ9*6TqœäV¨â¨®S’:Ñ3†­3о|cø…ðâ‘ñ/ឯö/Yf9mæíµ;f Éku#Ì…ö®FA ªèÈ莽”+ºRº>{5Ë)ã©:uü?uçýl`ß ~#xgâçÃßüKðu×áÏØE}nây Ü>xfòÝÕf‰ÃÅ";$Ôœ©¯ „”⤶gäèO VTj+8»ÝQˆP@P@P@P@P@P@P@P@P@P@P@P@P@/ì,uKÝ3S²‚óM¼‰à¸´ºeŠxœdt`C+) ‚0AÁ ñì¯û?ø–þ-KPøiaoq"š4÷\EC3a¶’8ËeŽ\©bá@gâÿØGào‰Fž4‰|OáaoæyŸØ:©—í{¶ãÌûbO»N6mûí»wË€ ôØ;ör°Ñ­t­gúψ/"ß¿VÕ5ÛØn.2ÌÃxµ’†ÐB±¯ 3“– @hŸ>xgY³ñ‡>øCJñ¦óo©éº¥µÄ‘‘¶J‘†\£2œCКôz(á/²Ä—/kâß‚:-ž§—ç…­<«;{„Q-°%c‰ÔczeUÔnpD [ø–óHÔ'ѵÛK­/[µØ.4íF¶žÈ®¡âpIFV†€;›?Ã"®.?Z܇ÄÑôó†>´²xŽ?ùì?:θñ{Oï‡ç@½ïˆâç÷Ãó VñD#wïÇç@O¯xÆÖ%|Ü ýhÄuê>"¹šÃÖSßݽä€,‚F÷$*çiÆHÉÖô0Õ±Rå¥ÿ]^Èò³ló.Èé*Ù…eM=¯«z¤ùb¯)ZêöNËW¡Öx+áRiº¬^"ñ=Ü7ú¤'u½´JL6ÎáòØ.ØÚFT9êB°ú¬»%Žj­f¥%²è¼üßm¾æ~Æ~&VÏ0òÀe°t¨Ëâ“kžjËݲºŠ½Ó´¤ä¬®“”_¿Àñ ›ŸJú$ÑøäâØÝcÄÚ?†´‹íw[¾ŠËI²O2k‰IÂŽ€9$’Q’IH±4ðÔåV¬­»þ¿¦m–dØÜïK/ÀRu+TvŒVíþI%vÛ²ŠM¶’løâ§íAâ yî´/‡M¤hÊòFú×ü¼ßFSoîÔ®`,CgÌá1Ê~8ã ÔnŽÝ޾÷V¼¿—óÛmQý{á¿ÑË ‚<ÇŠ’«U¨µGìS•ïï4íUÙ$Ó^ÏY+TN2_'Zéé Ö¾¥f÷?«°™l)écf8Œ\ÒÏn–AhZHë7#²‹qPtÆ$¡j[5QƒéH« Ö¨‹´P6†ê(L‡¥iÜ—…*®fà0­;âBÉT™Œ 4®;S¹.6G_Jfm•§s'¤xª¹.(…—=)¦c(¢"•W1pF)™¸‘TŒ¤ˆŠ{U\ÅÂäM¥RfR¦BÉ‘‚*“0•;•ž!Z)³¤Rš0À‚8­c+©)+1ú.¢Ú6¢²±Í¤¸I'…ÏÞÀêG=º;ÒÄÑXšV_Õ—̼“2y9TzÒ•£-ôWø¬·qßgut·¹ìqÄ“"K‰Àee9 Bq_6Û‹³Üý¦…hª”Úqjé­SOf˜¦ß¨æ¢DÐúŽ*¹Œ¥D©$xéT™Ï8%@zÖ±gZiî]ð÷†[_Ô m•³ˆ‚äuo`ké2<³ûBnSø#¿Ÿ—ùõûî~+â—®ÃF†ÏU>]Ÿ"Û™­ÛoH]r¶›wååPøðZÃQB©€¿H£F0ŠŒU’?г<Ò®*¬ªÕ“”¤Ûm»¶Þ­·Õ¾¬õýDUHÞEùGE¯B>çÇã1­¶‘ßZÙàJêŒO ­SzÒÌ’¬bpU­mΖÚÅPßJÙFÇR»–ÆšF2г™ÈÓ†¸'­ZG4çsÏüaðká‡Ä $¸ñ_ƒ4û»é%Id¾„5­Ì¬©±wÏYBàmf#å^>QŽ^S‚Ç>jô“}ö}·V+ŸWxƒÄü-K)ÇÔ§M&”/ÍwÌí ©A6õæQOW®®üÇì¯ðödšÆcŽ!äê¨á%¶lnfË1,I<¯†ò¹»º+ï’ÛNï}wzží/¸ê‚å†e'«z”äÜž²ƒv»ÑmhÅ(¤—)­~Åßµ[Ø®´æ×ôH0†ÓLÔ‘»NònWÜA† 8$ñ×á ¶³¼T¡äŸãï&ÿC貿¤_e´œ+N–!·~j”ìÒÓÝýÜ©ÆÚ_kݽmd¹³û xêþpñ—ˆ†ömŸcßíhÝŸ3Ïòöù{8òü¬çøùk“ýHÁ{KûIrÛm/~÷¶ÖéoŸCè_Ò“‰Þ“êt=¿7ÅûÎNK|<œ÷æ¾¼ÞÒÖÓ’ú‘ë°ß%Ó®"Ð|oâ[=Xíò®u³]Ÿ0ݺ%Ž&l®à0ë‚Aç.¯à\Z§9)wvkîI~bÀý(x¦xˆ£:ZÞ0S„žŽÖ“•Dµ³wƒººÒ÷\ZþÂw Fï‹a‡ý€qÿ·UÃ.‡LGþKÿÛMOé[ˆMseÿ¸ÿýÄÕÑÿaÍÞîWñ7ÄmFûO1évÙH²daŒŽó¸Ü6ì$Œ`íCðð•ëVr^I/Ï›ò<üÓéK›â)(å¹t)Nú¹ÎU-ž–Š¥­í­í£VÖëvOدázž¯á§Í+i½­²½Ú<—HŠ÷Ã~"Ô¼?«é²iÚ•¤€ý–WI–Ü«#£2ºóŒ†8*AÁWÔa}¥/Ý×VšßoÓOø:…çϘ_–OŸ6ù]¤´¾ÍKÞVé}Z´ºŸOxbü´pºµ{Ôg¥ÏÉs:“L÷ S" í^)è|>7ïP½ 2 mÌy¾É¡¦í¿Ï½Áì™Fæóåoš¥ÈÚ-NFþ÷¯5„¤z”(œ«¨Iâ¹g3ÝÂйã^(Õ¾GË` óëÌû ³ ª?>¾&k§]ñÁ$Ými˜“¡³óú¿$âŒrÅc=œ]ã >}EäÓ?Ðï¸VY ýr¼9jâŸ7Ú¿³JкvKW)&·Œ¢îôKÎJWÎ\ý¡ÓcÏj|Ä:c*jFr¢GäÓæ3ö#LÒŸ9/Fmù⫝̸Éá†ý›=¨U xR´ÏJµPÂX>ÄfÏÔSö†oBögÓ5j©„ð/±³øj½­Žw‚O¡ ØÐb­V0ž\žÈ€ØAUíŽw—yµ€îµJ±œ²åØ`±öý)ûR_ä;ì#û¿/jWö‘4v˜©u éà¬ZKr1ÜVnh놣J)Ž+ »ž¦Ñ>qž sÉÍ)ß^¦šÏµÍ`ãvz±¯ÉÓ­Ÿ[Öt¶\,o±•Yc3°'Œ„V?‡CÒ½L¯õÌL(ôo_N¿ðœyÅ ‡2LNau;[¦Ó“Ò ¥­œ¬ž«}ÖçÜÚN›ˆ€•û8&óoˆ”[;ìb…P3Šèä±äJ¼¦õ+ÏÁãŠMBg+¨Kå–U^}k »ž<Ûœ>¥pU]› ®i³ÛÃS»I[ðš]ºšF®, ÷§â¨Þƒ?S>"È-_±Å}® ^Çó¾W$}a§ÙÛÈä cÖº«T”]‘àe¸:5aÏ= 3$åŒçè+89-Y×^îÃS2kRpkxÌó+aZ[sñ^ ð?Œ¼bl~Øt*ïSû'™å}£È…åÙ¿ní˜Î3œ•8ºë‡©^×å‹vïe{pþS,ç8Áå\üžÞ­:|Ö¿/<Ôok«Ú÷µÕöº?˜¸º×á?Õú;špÖ=j›b¹§©íáß)³ô湦k3Všç‘ìPw4ÀïX´zPšE¤” ÍÄëRÂÎ*\MãX”\Z\…ûq|áëK”¯mpRå)U¸4€ŒÓHSÊŽùÏ5i³‘]Z9äÈZ©H®ã5hæš¹]…hsI%@jâÎ:ÐLûÇö*ýºõ¿Ù?ûcÂ:߆?á"øW­ß¥ýÍ¥£¥½î™r|¨¥¹ÊâlÁƒ…C4q•’/Þoôp¸·GÝz£ã3ì‚9«S|µù5Ñ?Ÿ_ÁéoêKÕ4ÍsLÓµ­QµÔ4mBî­/ì¦Y¡º†E ’G"’®Œ¤0`H ‚+ÛM5t~a(¸7+4_¦HP@P@P@P@P@P@P@P@P@P@P@P@P@P@P3âßxWÇš4Þñ†ƒg«i2n>EäaŒNQ“̾ôrwD!—qÁðoÄoØwU[ñ¨üñ„ösM™4OÉ&ËU&F&˜Ñܪþå9›™¥'€|¯­|$ý¡ü&4ñ­ü*×äk°û?±ã]Wnݹó>ÊÒùxc~7`ã;N<ûÅ:—Šü 4ñãjþkï3ì£]²šËí;6ïòüÕ]Ûw¦qœn\õÂÜüNÓ‚œêÿßÁ@ÕÇÄ%¼ŽG±’K•S´›dip}>Pyä~u¬(Uª¯¶¼“g+4Ààf©â«Âœš½¥(ÅÛ½›ZhsW·Þ*Ô–#e`û&ÛóÊê›îÊNáŒò1Ÿlñ]ʱs·¹dûµøõü.|æ+ø Ξ#šQ¾‘ŒÚè¹]ú>nW½í©Ÿðþk÷óüS¨4àçý ÑÙ#þ!ó? ÜÛ_Ûnœ¯ä£%¢]µŒ›V¶·Ý³ÑΚøÎ+ɹú¦RžÅ“ŒSLÎTîdÍnTEh¤rÔ¤bN1šÞ“ˆV=Ëáþ‰öM:d?h¸>c<ôúWêù a0‹^ôµ~¯ü¶ùçïŠÜNø‡ˆqc$éRnœ,Ó\°oTÒWRwšÞÜÖ»IAéaX#ë_IN☼Nç¤ØÚà"À®ÈÄùÊÕwgQom€+t2¥[›Ö°lÁÅkpUÍTVâ¬æm"CœÕ$c)µHÁ²Ò/zfm’`Šz¢4d€óTI(Î d NqI²’!fÅIi984™¤J2žjMâŒùO¤Þ&dëœÖl郱•4#œŠ†Ž¨M˜×0õâ³hì§3âÜœŒVm´ê7V§"²”NêUNfçOG-•¬\NvŒ;&œƒY:hí§‹’9OEV °dzV¦zØlk[œ|þR[ãŸO–¸å„¦ÝÜWÜ} ÆSŠŒkÉ%²ææ`Üh-c$w6‚[k¸™dŠâ!¢prH<@9ëIÑä·.–4Ž`ñ<ʳçR½ÓÖ÷Þ÷ÞýODÓþ7øÏH·ž)ôø®ïÛ{¾IèJ`Ä‚r09à WTsÐM5wÜðjðnY‰©Fn0_e«ü¯u§­ßvr/ãëý__Ò¯ïtå·•7E,þ`‘æ A\¶Ðp§wÇÎkž8‰J¢“G³W(¥K :Tçu£JÖJÛõÝé÷#ìŸê[xÑ8#µ}wGã9ÞFm=ÑïZUðD<â½HJÇÂâ¨s3¦‡R#æ¶S<Ùá‹&õ\d|×3TZ(\^ü¤f¥ÈÞN?Q¿ -\ó‘ëaè^ǘkš¸þjã©PúlcæOо3:N›,P>oçùgîç¹ü3ùWËçù¯önÔZÉè—›ÿwÓk\ýÓÂN—g”ðsn4bœêIZê1¶×êäãÙÛ›™Å¤Ññã+3bK’Ozü~SsnRwlÿGia©á鯍Â)$’I$´I%¢Ih’Øg—K˜·L<¿j|ÂöC|º9…ìƒÊö£˜=žWµÂö!äŸJ9…ì0ûSæ¢'‘š9Éú¿ß#ÚŸ8ži·Ïj|ä<7Ãl=9§ÎCÂù5¨ô¦ªK»›\vªö†OˆÍ¨ô§í Þ›PqUí ž.ƒ~Î=)ó‹ê˰¾@©s‡ÕÒè«7£,n n·?P~k¶³­ªîãöy}TÒ?™ø»:nLû ÆxÝQLƒé^…V‘òÊiEìuÖöÒ•\–'°¯>­f±ÀeÔçk¦G«ÛÇœtǯ 74rg8XaäÒ>xý ‚ìTÕ¿ôŽZ3;ýCþ é,\Ëþ¶åöCÿNÄþh£ãø¬ôꞆœ$qXI­ ±5a$zôdiÃ"ñ¹°+ ÄõhT]Y¢.ÀÀN`éõg§bJÑ&KŽzԸė–q€I¬\øâ®Ù ¸¹ V%ûÒä-bçûÒå)W'÷¥ÊZ®/K”¥\i”|¤º·_=騇22ÕV2r!fIXÊR#<ÓF,…—9«LÆq¹Uãö«Lã©Lý ýƒÿnÝSötÕ-~|J»ºÔ>ê’Ž¦›Â³HÙiàQ–{fbZX 2Ä7ù‘Ïéa1žÏÜžß‘ñœAë|2µEÓù¿àö'ÒßÑç|u቞Ð|yà=z×Y𖳸²Ôm Û*ä‚ 2:°dt`YX+)ÙŒ”×4v?6­F¦£¥UZKtu”Ì€ ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( €<ÛâWƆô¸u‰>2Óô;Yóöxgf’âï7‘oieÚf~Ämƒ6&´§Ju] ®rc1Øl=¦&j+ϯ¢ÝüÍŠÿðR=GU°:_ÀÿÜi³ÜC¶M{ÅiMl̲)ZFî…Ô˜]d’F\†V…† õheN÷ªþKúþ»ŸŸæœL ,ÿšVÓ}’mvi¶×Gó³ÄÚ‡Œþ&x†|Bñ&¡¯kÓni¿”¿”…ÞO*5û±DG+EÜv^Í$)«EYšæ\C_7R´Ü¥Ýþ‹¢òZ"k_ [´¶òý’&žùr£ÈÁÁí‘Á®¥B-¦Ö¨ð'šÕ…9ÓF£+]]ÙÛUu³³Úûu®Ž±»òÓvj ikø?ø6>“ÃÌg°Í§…”¬ªÅÙ[yGU­´´yú¤ýl}7} 5»)òý+æ“?k”KRÓ¼¾BôªLÆQ±Âê)‚ÀŒV±8«lfiZkjš½¾3`Ï‘‘€zWÐäŽÅÅI{‘Õþ‹kkÛµÏÇ<[âÅ™YR•±¯ vvjëÞš´”—*ÚJü³pº³>¸ð®åÇŽ˜laAì+õúìœù¦3šN)ž»§Xm •æ»á %ˆ¯s¶±²ÂƒŠéŒOµmltZôâµHàSZ(:*Ò9e3F;luiò¨ZX}©ØÉÌb#š«äN‰ëM#6Ç”Åq»HæÜxû¦u+·&¥–ˆHõ¤Y œI—„ƒ“RoSuê*M¢Ê2­K6‹3eZ†tÅ™²¦s‘PÑÑ Ò¢Œð*:c&Ìkˆ•³•¬Ú:éÉ£kD9ô¬ÜNèUf5ͪ`â³”NÊuYÎ]ÙŽqXÊ'£J±qh'ŠÉÄî§Vç9wkÖ²’= UVîÆ<’TVŠ=ZUŽ~{uóaUÀÀ:ÖMð¨ù]ûIü8ñº\ÛM™nqÏu¯_ YÁYì~sÄY|q3s‹³>¡Ñï »…eòèzŠö©ÉI]™bèJ”œdަ'€+ty“E‡»Š1àŸZnIªR—C÷SŽîk9L죆mž«j¬Áðp+–s=ì.+)â¯%¢JƒMÛÑ~µæ×­Ê}žW—:­_câÿêókš´ó¼›áF*ÁϩϾ8öÅ~=Ä›ÌqMEÞº^}Ýõ½ÚÓÊÚn¤^ð,8; §*°qÄâgQ;û»¸C•¥Êã{É«ó¹.f”mÌùuásªû0拇³*‹‡³Êõ£˜ ò…ÃöBˆ}.aû!ÞOµÃö!äJ9†¨Žò=©sØ öséO˜^ÀO³ŸJ9ƒêèa·ö§ÌC 0ÛûSç!áÈšßÚ©Hç# W1À‰àö¦¤c:^N;Us{ Tù‰tD⋊4ì)ދӏ¥q¨Ù9Âý*–æ5‘Ü|.Œ.»©^ù˜ò¡X‚cïolç>Þ_ëí_cÂôÿy:·Ù[ïðçñ–Áá°¿Üï}¹#kZÝ}¦÷ÒÛ;éöN‡s›ea×ú '¡ü}§ïØéౚÙ3ÍœlKpB©4äE5sŒÕˆØÍ\õgµ±æ®\?¥qLú\.–<ZfµÕ£>ò7Zó*{³¹÷84ªáÜSío‚>-æÏ÷¾ëè²Úûq¦Uñh~ŠøWW²¼òžwf±^Õi¶®ÌrÌ-8Ë–kcß´«ý-m‚ZmYqÔžµç8NNò>Ê8Œ5 |´·0µ‰÷¿Zõ0в>;ÄsÌùŸö—×´¿üø½}«Ýy³x~öÅc>f¸ˆÛ¸POÍ,±®z Ù$HÏ8« 9uyMÙrµójËïmž`qŸeTpÑæ’¯Nm]/vœ•I½ZÚ“¶îÖI¶‘üÛƒŠü`ÿLS±¡p ¬dF„´»/¬µ‹‰éB·bÔnݪG]9Éì\›ŒÖM#¶œ¥Ôº­ÔÖMЕº“,‡±©²6GЙ\÷&¥¤o©(“Þ¥ÄÚ5ID†¥£hÔl=Mdž>´š4Sd€œR.ì2}h °äÐ;64©â6™."§r\HÙ3Úšfr…ÊÏ犵#–tYúëÿ¹ý«î|ãgê·RøCÄóÿÅ1=ÝÜ)o¢j‘ÞÜ 0Á.بUW8¸Ú2×8õ°‹?e/‘ùÿäüÑúí%ªø¼×—_.ºÐzçç@P@P@P@P@P@P@P@P@P@P@P@P@P@â?¿iŸ î¤Ó¼wñ/G°Ö"ž;i´›g{ëÛw’3*mmÖIcR˜`î~dç.¹Ö •~Üóñ™® þñUEöÝýÊïð?*~6ÿÁA¾%üI°—Ã?´‹¯éOsúÛ\Ç>£}jÊÑÆ÷x³m¬]Œlò+„òå]¤¿­C+IÞzŸŸfÜu)Eà ¹ºÞí®žÒúõÓ_Šf³×{è·:ë}0à*GòA[¨MLOVÍ»m1ÀW¯zÕ@⩉OvjŦ·uÍZË,J5aÓv€YjÔYâo±u,sÀ^*ùL]cø…âÍ?áÏ„õßÁö†‡lvöK*Æ×S1¢–üYˆ„V`­ŒWg¥•a¥‰«Óeݽ’üßd›è}Wð¦;3º9.ÙÎîS³jZÊR·Ê1»IÎQ×5ÏÌ¿x]ñλuâ/\ù·³|«#·Œ¶8×'j ž9$’I$’Ìs*Ùw^»»r]—’ÿ‚îÛgúqÁ|–pnYO+ÊéòÓŽ­½e9;^sz^NÚ»$’QŠQQŠ¡ƒŠò¥3ïháËËVNG|iX”EíJ摦J"©¹ª Lv¢å¨ÙJãä#ö¢årÏj<º.åûQpäR‹‹O/Ú‹‹o–)Ü\ƒLt\—¦:w(Ó¢äò )íNä¸ )Nä8 )Nä8 )Nä8 )Nä8 +í@œ2Us9@„¦*®báb2´îe(²æ©3FåY¢gHا'zÖ' C6nõ¼2±•?zèãbZý›¬´¾7ø*È ™>ÙÇÒÎsý+<Á_ 5éù£³„'ìóü4¿Çÿ¤Hý!ñ‚|ˆ¥–Xð·ZùG¾Æ«–§Í¾#·6Ï )òä㎔"ª#È5r n+hžmec¦øgf“ÞÍ,‘äoÆq×üó_¦pua¥7å¿t’ûÒwùÜþúIfNyÝ5:·Té+Å;¨ÊR“wWÒR#{7Wµ®ô+XÂ+c§Jý”Qü‡Ž«+Øô=6Õd`HàWT#sç±\QÚÚZ) ÇÓž5Z­1Û¨À´Hä•CNPH«Q9§Vå¡N)ØÉÌ™`ö§bÉ^ÔìO8¾Oµp1J,à DzÑaó (i¤BÑ“H¥"CÜR±¢‘]Ðò;R.,ªéíRѪeGCI£h²„±ç&¡«›FE #©h茌ébÅCFñ‘—žÐ`’bµíRV?5ÇMMx»`»D‡ë[óG²MÞÅIn›'"“‘¬i£òè$šÊR;(ÒÔók~J8WÁõÍqÖ©cé²ì;WGÈ^7ñdšÄú}“‘l¤¬²ƒþ°÷Û××é×òî'Ïå9ˇvŠÒO¿÷W—GÕ½6½ÿ»ü ðŽŽ CŠsˆsU—½F›NÐWÒ¬“ZÉüT÷ŒbÔÓrqö~må{WÄ\þ¤öbycÒ‹‡ ý¨¸{1ÞQô¢ãöc¼ªW¦Oý°ŸJÔ¿g‰¶º¦³ýŸl-`•'ò}óGs ŵyl«[º'™¸ð¦¼~"Œ%–VS••—Kêši|Ý•ú^çé ÕÄP㌶xj>Ò\ÒMs(Ú2§8ÎWÉ)òï.^U«GóþM~BÏôY+²ôJ[”ŽúQr5`¶fÇW<æ‘ìa𲑩±«Ìõ©ašè^Kf#…5“¨wà ßBajÃøMO9²Â>Ä©fìFÕ5.¢7†O¡¢4{¯,H>Õ>Ñ,‘\Úȇ ¤z\赆’èH¶òƒš—4h°òD†ÚDê¼zÒæEû ½(æ-Rh!Æ©¹¢ƒ!¢å*dŠžÕ-šF‡˜ý©\·Ha‹ÚŸ1›¤'’}éó Ø°ò}©sØ‘´UJFr¢>ÊóRѵ ?YÑu ­?Y°ž;«Kûš ­fƒ$‘Ȥ2:° AŽkZu]ÑÁŠÁƽ7 «§Ðþ¢ÿbÚÿôǀ,t][Qò>4ørÆüA¦Ý˜’MGhXΣnQZ\‚êŠ<™aLO'Òáq1ÄGÍoþgâYöKW)®Ý¿w'î¾ßÝ~kñZ÷KîJê< € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( €9xÛÁžÓàÕüsâíúTó‹X¯uÛølb’b¬Â5yYAr¨ìáXö4ã'h«™Õ­N„yªÉEwnß™òg¿à ß³_„~Ñ—âWÅš…½ëYMiá}5ä ·~é–yÌ0K䜯,lì’z(Qr‚ºåMIÍÔ¾²N<–³æGÍñ§b¾Lþ¼¥ ‘£p+îzp…‘aSÚ¥³hݱÔÜÙDF})\¥Â"zÑq¨{W+”p‡=Ê/}(Pò¥åÛ3ƒ@¹Fh¸r·-Ú‹‹”G€©ö§qr‘˜}¨¸¹0àdŠ.'3§r\˜©Ü\ƒ '(¹. >ÔîO³b¢äºdf:«™¸”§rÊS¹›‰-Rf2%Rf U£žjÅ9k†ª3ä­¢yÕLÙëx^ Èžº xµÎûàuÍݯÆï„ew5¼²ø“N·i ÆÍ· ˆHþGeaЫx&´«*2O³8°eG0¡8;>xíÙ»?½hüÛÏiÑ k€ äÀ¯•«¿åõT“>ñ&eEçžk•å]ó¶·3†^=k¢òq=á…®ØCÕ²3_°ðåc¥ßKýúþ§ù»ã>iý§ÅXú¼¼¼³pµïü4©ße¿-íÒö»µÏª´H•õ”Ö‡óî2~ó=/Lƒ 8®È#æñ3»;KHpƒŠéŠXñš–ã#:TëPΘ³2TëPΈ3*tëPΨ3á:Öm”äaÜ æ²’;iÈÁ¹AÍdÑßMœÝæb-žÿÝçôþ_?›c£ÃN¼¾ÊûßE×w¥ú®x{µ¸«9ÂåT4ud•ô÷bµœìÜoËåËtåk-Z¿Îmf,AÉ95øJ³­9T›»m·êÏõ€¡—a©`ðÑå§N1ŒV®ÑŠI+¶Û²[¶ßv'•ìj.ur">†‹‡(ñnOj.¤¢ÛœÍ)@”ZŸJW)@³‰nÔ®Ratóèi\¥ôKÈÀâ•Êä.ÿb:4\¥Lž=GÀ i\®BûxnU@ÛMbI7b 7÷M+Ù•çО4Ý´Ñr\ i4â j“3p(Ma´Ši™Ê4°•$Ws @¥$xê*“0œ lµiœÒ‰-Rf‰Q‹DdvªFmµR1‘Rn„V‘8«le.Vv`pp9u)8¤âìÑáΔ+JtêEJ2ViêšwºiîŸSßüâ¤X#óeAà ÷¯Ñò¼zÄÐN½}zÿÀò±ü[Çœ'S#Í*àìܼëð»Ù]ÛI4­Ìš[û§k1\“C *}Cé^ì*&®Ê19S“Œ‘×Ú^,Ñc<Öñ•ÑäÕ¢á!®ÊN ühÐi4P»·VRÀu©’7¥Q§c‡Õôä¸Ð¯=«š¤.o ˆp’gx—B–Þcsm¹%Cœ¯åÖ¤Óº>ï-ÇF¤y'ªfß‚~$ê:=ÌP]¹!N7g´ÃbåMÙœY×QÅÁΚ>Ýð7Ä‹køác?ÍÆy¯£ÃbÔúŸŒg\?S ÚHö)þ'ÙÚEåG(wžw¼\b´>J<;V´¹š²>Eý¬~,Z]|(Õü37Ú$¹×&·†DƆ9£œ—n‹ÄD’ÄžùÎ#ÇÇêR¤÷›Ivѧ¯ÝëøŸ´x-Â5—ÑÌ!eœ¥w«æ„©®U»ÖZ»(¥»»Š—öí!Æ¿7œùOí\6UYÑZØŽ+Š¥Sé°¹}­¡ÐÁe…/Zâ]O¥Ãà,¶6-ôÂäÏ:öØö°ù_7Ät0i @Ú•‡¶îz¯-I{¨´šHá<“è*]SH`<Ž–ËÁï…-Íô©ö§BÀy•—…K!¢ê=(ö òÿ#6ïÁÜæ”{QíCû?Èçî<&ð6èâãÓ{Pú‘UôBPƒzŠ= ¾¥äeÉ¡“·ò£Ú êE6ÒÙÝ8§íõ?"&ÓaG´Õ<ˆÍ‹¯j= ¾¨Æ}™»Š9ÃêÌ_³{QÎWìøê)ó°`#µĺfj¥#)Q*Ë\drU¢u¿ þ'ø·à‡Äo üVð,Ö±ø£Ãó´Öâö<3+ÆÑK‰Á)$RH„©WÉVV‡n´©ÍJ'Ìçyu,fTªìû}éýçöw_V~P@P@P@P@P@P@P@P@P@P@P@P@SÔ5 &ÂûUÕo­ì´»(^âæòîUŠ+x‘K;»±UTXši6쉜ãN.svKVÞÉœ´?íó¢hú„~´ïˆæŠkwñQÚiS‰6fÝ6ݶՑƒçɉ™K õ0¹dêZUt]º¿òþ¶> =ãŒ>ô0-Nvw—Ù‹ÛM=çøm¾¨üÕ¡ño޵+}wÇž&Ö|E«C ÛCw®ßÍ}2D˜ yYˆ@Îä(8Ëߟr–0ÙXü³ÄU±ߨäö»wÓ¶¦î™áܬЀ«ÐÔ×d(7‰Í¬™ÛÚxlª± ŸjéÄ«˜½Û;M8Ô*Æ?*è$"®=Éݳ ²ÐUØ~ì`{V±¥s‚¶9¥¹Ò㪀øVÊ™æÏÞ­šöú:®—óÑS9*bÛêjE¤¯JµLæ–-÷5môelƒò«TÎZ˜¶ºš‰¥*¹WÈr¼Kf„:° ¶­S1©ŠiÚåôÒTéUÈs¼Sf‹õ­ À~ñ|E/•£èö¯s6äÚ>XãÞʦGm¨ŠHÜÌ£½a‹ÄRÁa牬í«¿òW¶¯eÝèzÜ?”c¸£6Ãd¹ty«Wš„tm+ï)r©5+Êm'Ëå²?%Ô5wRÔuÍbãÏÕµ+‰o.ç(©æÍ#—vÚ (Ë18ž8c±ÄÖjŽò“mú³ý©á|›“eØ|»ZTaE]»F)$®îÝ’µÛo»lÓ†>GæÉŸiJ‚­dÙÝ—#‡Œš–ΈÂÅ•‹Ú¤ÑD°¶ÇŠ.W(«¥a+—ÊL¶ý(¸rŠmÁ=)”rZóÒ€å'kaŽ”\9H~ÉžÔ\9 c´ÁéNáÈ2[\æ‹‹”ªÖ¸=(¸¹H%„ä*Ž}©Ü—>ÆÀdç4\\„g9拇 ~:S¹<…v‡¨¸¹?lÓ¹.$&:w2p"hñÔU\‡³.>”Ó1”HJÕ¸¸ªLÆh¥'zÕIëTpÔ3¥­ây•™™1­ày5Ù‘?zè‰ãW;Ïà7ǃHziÿàdU´¿‡/FyÔûe44~ë|Dµ‚Þ™·Ž3Àâ¾_d~ñ’©J×> ñž² y¸\gÒ¸¢}5mO›¬ Ò´ÜGn “^ µ>?4â7Qò¦z¬> cnÞ\8ezWjÃè|¼óŸVh®©S‘úP©„ñ‰²½Æ—å)$sIÂÅÓÄó3ˆÕ o›$×5D{XJˆòÝh8WHø'«zWCéðM]6|Ñãü±H”â4˜ôçó¯‹âÊR«—Ï–þëNË®ºßÉ-~WèMýñô°a†öʪ§iÚñn-Ç‘¶­94 ·º›‚W‘æ^E~Ksý åCEÔ•m³Ú‹‡)n;LŸ»Jå(–¾Å“÷i\¥Ü:cIÐ~t®_!¡o¦ºH¡“\j&ì:)‘†ŠW-Dë4ÿ}ß“ô¥r¹Nˆø_{‚"÷éJå(šÖ¾9Êý)¤gQØÜoæû®~•mñ–¦\Þî¹úT3¢2¹Íê¾dG“ì)\ÕÄãï|6ñÆduÁì)܇ˆ½±(XäU&c(¥Ý®Ö;´+ìòÜþH¥ZJ2ë}½S–ÿ™üÑÆÞæ8:²–]JU©_Ýq\ÒÖþ좵º·Ä—+ÓfùWÑZ'‰m&Éë$N2¬§ ×ÕÓ¬žÇàܶ¤RVhíê€eqÏl×EÓlÿåÿáò>Ž>ø|´YbÿÁ•¿ùaÇüJŠM[Á׌ÒÜM-”‰tЬ[$¬O^;žØÆz œ6m‹Åb’ÄÕrRèÞ›ie²}6êú³lïÃîÈ29Ë%À”éY©F7›‹—¼¥Q§RQI¹YÊË•tŠGÎÚ|œâ½JÑ>.«}¶ÑÇWŸQcƒšÐéíŠ+‚gÖaZhÞ·+‘À®Yå 5™N>QY3Ѧ‘è¾·´š@%2{÷¬›g\!ǨXé)3†×{z*æ•Ù¿³c¸‡ÂkköËÈÒ$詜³Lv¥v±èŽ’é÷Ö\™Y³•u§¨šc™Ô>éãwïò]‹’,áõÄZÇqÆqUäcZP¤®Ì‰þ2CšZ¢’§%£0î>‘±¶ió1:QJæ-߀g„n6q’1Z4â®q¤*IÅíáÏ1šžcwDÎÔ|6,à2ÔԌåJƾóÉ€§hêióé'ÓÌlà >b]+#>K|ÅUÌ;•ž- š¤ÌgNÈÌ‘:Ö±g X\êþx;Lø…ñkágÃýj{¨toø“LÑîæ²eI£†âê8]£fVPá\J‘œd•Û…ŠHÅõhùlú¬°¸Jµc¼c&¯ä›?³úóùØ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ü•ýµ><¯Ä «Ï‚þŽá4 Q#ZÔ¤ˆß]ÀYMº¦@hc“’\ÒÆŒ Õäú\«.qJ¼÷{zwõý?ĸÿŒáV¤²¬/Ãï½Uä´åKùSÞûÉ+Y+Ëáë/ àò²ÝÎ:×ÐF‚GãÕ³II·s¬³ðê*Ýqô®ˆÑ<šÙƒos§³ÐTûºÚ46¶9¾§Gk¡€A ÍkgWæoâ…Qòsô­U3†xË›vºHE'ÌkXÓ±ÅWÌ÷6!Ò²õ«P9%й±’0 ´P9'‰-&ž7·¥>Rm«ˆÛV£¡ÏR«“,›0á¡Fv.Çl@©+IÝܰ°gŒQq(·±ùõÿÖ¼O§x+ÀÓáž? k„Ϫ]IJ…iaTkx$u;6¹ydØà’ÖêË,×Àñö&µ,*Tþ 7ÌõÝZÉô×WgÖ)­ë¢>G–cx‹Å´ñTiÅR‹å¿,Ü•J‘Ms^)BÑi(Õ”e~t~fÚD¦¿©+³ý9ÁÑP‚6!¦+žLö)@Õ‚ß<‘Y¶v‚BxÅMÍ”KðÚq¸ŠMš(–ØÒ¹\¤ÉdXdŽ(¸(“‹öi\®QëbÀð¼Qpå%[þíå'[#ÇËH9I>ÆOoÒò‡ØO÷JaÊ8Y0íúRR'²cü?¥1r6œÇªÑpå"þÎÚs¶‹‹‰ì›û¦‹‹”®ÖMØS¸¹HÙ‡U¢äò”žßýži’âT{v?ÃNä8•Z,S!Ĭé׎*“2”JŽ˜ÍRf2‰Q†2*ÑÏ$V~õhæš)H:Ö±8*”%ïZÄ󪙓µ¼O.³2æ5ÑȮ̙tDñë³Þd½'HÖ¿hհžÊ «‹åBì›g¶¶šâÊ~Y¢±ÐíÁ W“4e•SlÊŒ'µï÷&×âÖÿ‰ºä mt‚`[ž¯•Ä]³÷Ì¡B1Ñê~xø×Pk™æœšÂ(õkJljj A ×Táâe¹ôïÃ)ÇØìœ«¢œýTWî™}HÕ§wM&¾gùOÅø*¸,el&"<µ)ÊQ’ÑÙÅ´ÕÕÓ³[§cê ·(8í^å3ò¼r³±éÚ8É» |Ö.çkhÅtÄñj»ðÆ V‰3‘µ JqZ¤rNNå{S±›‘:ÂéÍ;äÃÉô3À)X|ì ö¢ÃSd-©X¥6BЃž)Xµ2³Ûõâ•Ênyâ¦ÆŠeI ö©hÚ3(É©hÚ3)Inyâ¦ÆÑ¨P–ÜÔ´o†t–çÒ¡£¢5 Zœ*\MãTÌšÔóÅC‰Õ ¦l–D犇¢5Œù¬IÏ'D+™’iÄòV¡ÀèŽ ®t–n‹IÀÖ8•{-ü1öŽY öÅ5G˜Î¦déètV> YWÉãé[Gsϯœ8«Üõ=ÀÐı³Ãô®¸ÐŒ-sçk敱ÞÏ[™gáØ ~L¨àq])F:$ªUª¹š4>Å Àö¢±Ë.n¦%Ö•/"¨äÔ¸-Í!ˆ’´YÃê– oïô®yÄõðÕ[<ÃY„ ØÇQKƒžÇëÊÉ^}Së°/T|Ûãkuh¤cÀ_›õàæT>³B¥Û™5~×V?ZàœÛû6Âf<œþƤ'Ë{_’JV½¯k^ÎÝ™æÂÜWáw?Õ‹-°8ãšW‰z;"qÅ"”M¬‡PW)«š\ƒ·Š)Dè-4¡ÆV•ÊQ:;mLTù|úâ‘J'e¦ø\¹Ž‚¬wš„ÁÛ…ÅæKs´´ð–Bå2qéT Ù•LL"t–¾~ì~Uª¦Î ¸¸ƒÁø&>Ý1WìŽEާsëÂ=wúVn›;)ãiœ¶¡áU.ñp;â²ph杻…M<»_ðûÁcàT›4xÞ¹¢y{Ø€¦™”‘庰RÃhÂHã®âž8«G4Ñ(­Ë4QU£’hªÕhæ‘U£žD Þ­L¥)àÖ‘8+= Voß8ôú×Z^éàÊ_½/Ô³VRG])Ölïƒ:#[¾Òdm)ò‰ËDO þÞ½ ¿7ÄeÒ´ãÙíòìÿ¦™ñü_áæOÆTܱöuõµH¥Í{Y)ÿcïÛDéY7Ñ7íI½ÚNÛÙìlIñNqlE­£ý¨Œ5†Ô㯟§µ~3¦©¿«Ón_Þ²KÏFÛôÓÔórŸ£F6¦-kc)Æ‚Õû.iNZ«ÅsF1ÕýïzÎÞã[yþ¡­êZÄÆ[û¦ç!:*ýã×­|f?4ÅfR¾"w]ÉoÓçk»»u?¦8K2 ¢©åeÚÒ¨ýê’Ò7¼Þ¶n*N1å‡6ª(¦­ŠóZ>Ö2.FçÖ¡£x²ò9õ¤Ñ²e™U/¬®ì&vXnbx\¡Á Àƒ|tæéÍMnþãJÌúúDño†˜ï_/ ½“4”ZÏÂ(dsoJw!S¹Áë:iŠf;x4Ó2œV{\gŠ»˜rw1ã#µ\YÏV&,‹ŒæµGR:DþÅþ ÿ„÷ö²ø¡Oìe×cÖ¼ÿ'Îßýžåmܸó>ËåîÏË¿vO©—Gš¼Wõ¦§Áña–WšWº·þÔ Üþ³+êÏÀ‚€ ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( Á߉+|]ø®Ì¼ÿÂQªÿé\µú\¿Ù©ÿ…~GñßTk;Æ¥ÿ?jél‚ÆÆ6™rz ôãá«×kDΞ×NG màVñ…Ï2®!­NŽßNqòÖªóêb7­tÅÀ8äÖ±ÁWö6bÓWŒŠÑ@ä–!›vÚdcñ­ÉS#@X.Aâ«•ûVYª: ,4Øôµ³ŠwmX¶¶þÔ9!ªRdëkžÕ.fñÃ6[K"{Vn©ÕOßBìv'Ž+)U;éåï±ð‡üVÔÁðWÁïŒgÅ–Ãÿ$ïkâxæ§6]ýõÿ¤Èþ ú+àÝ3¯6¿æúv‰ù#lrˆ+ñš›³ý/Â?q¶â¹¤{tV†í¸È“;bjÛùÇ,Ö(ÜŽÜàT𨻠–ò8 v5RÀÂÐ]‰×O?Ý¢ábôZ;°nÒ•ÇcB- <•4\v/Ç —ÿ–|Pµb’²¹i|;ÿLÿJAs"Qááÿ<ÿJW+”™|9‘þ¯ô¦•È›åi&ðÞ3ˆñJåØÎ“Bdÿ–t\,S} ôØsEÅÊ@Ú+‹Nâå+I£•þ.&=Ö™‚F)‘c[3•¦K‰™qÀp)¦fÑŒðãšw3h£,xɪ3’3¥jÑÏ4PqÎjÎY´G,ÊRžµ¬O>©›)ë[Dó*³6cÖ·‰åWfTÝë¢'‘\Ëšº"yÏmý–®¾ÇñóÀ·±±oùúØÜëYãåÉ…›ôüÑÙ”•|÷MõæÿÒ$}ßñÄEšuY2N{×ÊJ£‘ûõ,: ö>L×5"ZO›$š¨"+Èó{éÚF$šê‚< TϦþ6tÝ3þ¹¯þ‚+ö|—ýÎøcù#üÍñ;þJ<ÉÿÓú¿úrGÕ:Â%}-&~#ŽZ³Õ4¬„Ûæ1[Õ‚ Žk¦'‡^GMlœƒ[#Λ6£NjŽI2Ú&h3l˜¦Jm7e"‡l ËÏJvDñõ ¤ÊþYÏJV4¾‚<#ì%&Ux=ªZ4ŒÊ¨©±ª™Mí½KFªeW¶>”¬hª%¶Ïj–ãP¤ö¿ìÔ¸›F©JKOj—hÕ(½‰?ÃPân«^Àÿv—!¢®Aý’Ò—³¹§Ö”IS@ÏTɦ©ñþe cø+*‘²;pUÝI]›ú^‚‰”àñÒ´£œyWØô­'ÇR#Ë}:Wc妮Ϝ‚¯Ÿ$v= “"?º¾•å×ÅÞhûܧ‡ùpÒºèX›MòíÁÛZ¿4;•û;òZp¹?ʺ£PðªàßDs·ñíVü«¥;Äñ*C’¦‡Ÿê‘®±š=;jÇ“ë |õÅTúŒ Øñyr\ óªŸc{?xÎmîGÐ~µåâŒûÜž~üO1HK•üü¯v4#¶(*Ƶ½±8¢å$mAaœ|µ7*ÇKc§nm ¤Ž¾ÇH¯É“A[ÆŸ¢å“äý*’0K3Ð4íîü”ÔH•cÑ´±RR¶…+žf' ¬™èv>VÛ”ý+®4O¶b×S¯³ðä1€|®}ëxÑHò+f2—S\øy8Ž´öW9?´{˜—žT Å0+)R;hæ õ<Û_Ò€Gx®J°>ŠÕjxο§â6ùk‰ÃSé!ˆº< ÄÖ[D‡'Fêç„êöØ.qTŒdŽþAVŽY¢£Vˆä‘Y»U£šEwïVŽi²ŒÇƒZÄóë=zGvõ"»R¼O›©4«2ÜMÒ²’;)LÐGÍdÑèÂw,#VmP™mVl턉ժZ7Œ‹Õ 4äN¡¨±Ð¤L¯Ï½#E"ÜnCGD$ZY=ñSce"ärÒhÑHðÏi­¥ë÷2üÆÚõÄnÞ¤å—8!‰ãž ×Ó`k{|:]c§ù~ÏÃx¯-–W›N¦¼•›š~mûÊöJéôW´\nîÈlå4Tˆ`ª­5:kYF5ÃR'Õá*èmC/šå”Ov…m Xf*AÍa(ž¥*§_§ê‰_›&±”OF•S³Ó|E$L JAúÖN't*žÃá_Ãk4bú%d$eÇ©±Ðª&}£øëÃWHªdœª‹Ksž¬e'tzž‹â ɳ7üþµÓ Ánxøœ>"_ ëZ&¡á)š2×ÊĵÛJ¥>¬ùŒv ×»˜»ðyÃ}¨1¦­ý¥.ç•õ,zÓ”—ûcÂñª·Õ…ÚšØ_Œ—Äpþ#¿²˜;Y¬c=Çjæ­5-s-ÃJ“µCÅõeB_s/âkÎ’>„¬‘ä¾ Óm.UÁ(ûÖ-Xô¡.efy¾¥o ¬&$ c¯½"š±ä^ Kv Y”¤e+i¨mÙÈhæ‘Ê]H¼Ö¨â¨Ì —Ú ìóqQ‰úoÿ©ø#©øÃã.¥ñ¾ù.­ü1à8%¶³™C"_jwP¼& Æ2’$VÒÌò*ºº<¶§XƒôUåí^ÈüƒóX‚ÀÇâ›»òIúõ{z3ú¯xü˜( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € þ{ôY¯uIfÔ5+¹®µ ™{‹«©I'•ŽYÝØ’ÌI$’rI&¿MÃÁF*)háÌß:µ§R¤œ¥&ÛoVÛÕ¶ú¶zF›n[hÇJî‚>WRÇ[goƒœ{VñG•Z¡ÒÛÚà95²‰æÔªt6öØUæ´HáMM‡æ®Æ<×5!jŠfrWe¥JM—¬~Õ.FѧräVå±Åe)Øí¥†r/%¡'VN¥Bž ÉÙ"ôv â²uBž\îkç±ÇË\Ò¬f†['оšsd|µ“¬FžY+ì|ÿ-³0| ð\›qÿ…¨ÿÉúøî/«ÍŠþòü™ý#ôsÁÝÝñJåXۃØ÷¥\5g>"\±±q|;ÿLÿJSÑŽƒ¼u,'†Ïüóý*nÍô,qþ¯ô­¢´<êµ/Q"¼4ü³¬™ßQ—/…³ŸÝþ”®W)•'…ƒ/қЈ¾fÑ“sáó GúR¹v9û ‚~Ni’ÑÌÞéÀ3eh!Äåïl‚ƒ…¦™-•å¹♜‘…488ªLÉ£áqš¤e#aVŽi™òVˆä™FCZ#Š£(ÊzÖÑ<ú¬Í”ÖÑ<ºÌ̘Öñ<ªì˘õ®ˆžEvdÌz×DO¼¡fFžÃÄÞ*×ÖXÖÞ 4Y2’C––Uu#Œ`<÷yÇœÍFŒ!Õ»ýËþ ö~aeS0Äb®¹a;ÊI¯—¸ï¯o—ºø›ZŠìÈL¿9ÏSÖ¾y#ö• ÕgÝ,€†·Š<ÌDô9+™Ï5Õ|þ*¥§¾\C6—fÈùÚ€PköФj`é8¿²—Ý£üQþpø¯„­„âL|+FÍÕœº=&Üâôï'Ýlìô>±ÐÕFsÖ¾ž–ÇáXÖ4ŽQ+¾žÇËbôlô;!A=ëªùúïS¦µL•­¢yÕ‘·•ic‘²Ò®(½‰ŒÒ¸ì8( ®PÛÍX6Š å¦h X‹ËÎ(Ƙùé@®4ÅžÔ ö+µ·¯J,Z™Z“Ðf•ŠUÍ¿»K”µT¬ö¸¥ÊZ¬Vm;5<†Š½ˆ™“Êþ”¹ úÀeîþ”rÖXÓ¤‚>ïéG!KÉ!Òyåi(x (´°H?J¦¬g 9³Et0Ã!?Jã­©ô™{åiº~€r¤'Oj)ÍA]†/F¶9ûý25]÷W°ï]Ô+¾‡Êfy\j[#„Õ e¯ ¯[ï«?<ÍáÈœ`¬?ÔW«„øÎÕ;Õ_ïzVS;ðÊç•ë@äž+Š¡ôø7±ä:Úæ5pT>³ïdx‹•E¼¤ú×—ˆØûÜ¥¾tyä0t⿟ö#Z+lãŠW(Û´³Î8¤RGWea»c¯Ó4³6Ò)#дÍ|¿%\UÎzµ,z›¢ä§ËZÆ'J½OFÒt,•;+xS¹åâqœªÉž¡£è?wäý+²#æ±xíõ=ÇDT•æºãLùúøÝN’ÛE(­•3Í©Œ5¿±Õ@%F1WìÎ_­¶ÎsW°RŒŽ+*‘=%vž§ëÚrâL\`}nîñ5ª(pJàœO¬¡Völù×Å0 KÇÍ(Øö)VæVgëÀ—üi#IeªB·5hå™ÉL0MhŽY£:P9­Ç2ƒÖˆä™YºU£–eW=kDrM™Óœ[Dók½ÈÍr>×2Ê1øW¥{‰Ÿ_ž*q¾ßähA&Ec8Øôðõy‘¥Šç’=J3.+Vm±‘j6¬Ú:éȲ*:”‰•ªZ7„‹ÙëPÑÓ \”“U"t|u5-FDêøïRÑ´dYI­KFÑ‘âÝ'û_H“ÊM×–ß½‹$ãï(àžGaÔ…®Ü¿õzÊïÝz?óþº\ù®.Ê?µòé{5z´ýè÷vÞ;7ªÙ+^J7ØñË+¤x¯¡« Ÿàq\­&uVÓc+Ï©ëð•Ú³Fäôæ¹gßÃâ h¦Í(ÍéšPÌA5“‰èÒªmZ]”a“Åbâzê]ž¦0Õ p¨uZgˆä´uýáÙõéQc¡T¾‡­h^4Æ¢l±íš¨˜Nìõý'Ç\c÷ÜãÖ®ö9ýÍFø‹,d(Ÿ+ëš—6ᆅORí¿Ä$ yÿ­8ͳ:¸XÁoã|[‚fëêjÝCš8[»œ6«ã û±/?ZÆR¹èФã£8›™X³Éøf³;•£±ç^"ñs5Ì!…¥*“vI7òZ³úÏý˜>鿳·Á?ü3µKWÖm`ûV·j‹ýN\5Äž`Ž6‘b(Ù×x†(•³¶¾¾…%Bš‚?3lÂYž.x™lÞ‹²[u~®Ú]³è Øó‚€ ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( Á»<'âoøOí‚í´MNëM7B?/Ïòfx÷ìÉÛ¹ÆN3Œšý3WÛQKZé?¼þâl˳ øNnog)Föµù[W¶¶½»³·Óc]ªF9¯Nø|LÎÂÊH8­âµKE½¾vŒVÉ\ó§;±[€ic‘Êå‘-žÔ v-¢T¶m\´‘“À›‘ÕN“eèm‹Åe)ž /36 µôÍ:‡µC änZéùÁÛ\•+A„˯­¨tíÅ~ZæsÝ¡–]­‚ÛKàµÅR¹ôx\§MHôHùkˆ=jy=ÚÐù;öíø:~%þÍÞ/’Úì[j~'Åvþdž\R‹H¥óÒL#›i.6·2ˆòÁwW…ÃëxI+ë{îÿ™ú¿†Ÿõ{ˆ(MFñ«û·ÞÓjÍj¾Ò÷÷oe{έ¤• ~_R6g÷f¢”SGCjW#5Ë#ݤήЧËY3ЉÖéˆ Üx¨7‰è0DqRl‘ÚXéѰSŠ Hìôí7ÚqúP;¥¹ÝÙh*Ž~”¬ÈÝ·Ðñòþ•J-™Ê´`tVžŒ`ìý+HÓ8êc-¢5SÃëž­S±Éa{;ˆPúQq:lnßjw%ÀM¿Z..A6{~”\\åç·éEÃo’¿Ý¢èn <•ô¢âäcŨ ´¹‘¢£&®7ìëýÚ.…ìä=mCi9$\(ÊNÈ»ý˜TÛÁ¬ý²ØîþÏšI²õ®šXŒ-cR²G~.”žˆé­tv 3&pÔÄDú¼QR×gm¤hqKp v5åâ1n2±÷Y6AN½.t½NŽ-ê+ŠX©3é©dtiîM'•b°Hõ©\Õ^¦Õ=ž“Fp:µó«1ÞpkØÃÒMç9„¡&ù´8ýEŽá¸×¯FŠ?:Ìs)Jêç}6õbÇšíµ•˜ru'ÌÏ9Õæ ¸w®zŒö0‘lòíf\†æ¸ª3é°q<\“‡ÁUŸW‚ލð¼m Å/(çi¹ãúלU• jv’ŒšõIØý{ÃŒψòì&<ÔêW¥+µxÊqRWVjêú¦Ÿc’·\‘_„3ýaFí¼YÅIh鬡Î8 ¤v60}Þ()ö‘j2¹RÜ£ÒtË`6ñZDá¬ÎÿM„˜Óx؉—£A»iÅuÓGÎc'cÓ´ØÖ%Rz×lšÄÉɬ©µxÑybînA2ØV‰œSƒdÓß(¹¦äE: Èà5P(l5rÔ™ï`ð×±åZÅñ‘$$ñ\U%sê0”9ZvñK Izå”®{”©(+ž­¥Ír<·T$–«G,ÎJ~¦´G,ÌÙŠ´GÊZ#ŽeW­É2¤†´‰ÅU™w-…>Õ¼äâ¥dÏé#ãì¥þвÿÁo kV¶¾ý¢<àÍ+J²Öܬˆ³Ai˧޼[„¶ÆQ&7˜Œ‘îV’9¾›ØóSŒ^é#ð瘺XÚµ©»ÂRoï{ŸÌÕ¶©¢jzއ®i·Zv·§\Iiy§ßBÐOk,( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € (ò_ö±Ñ°þ— ‡×c¤¶„`q\3™ôøZljÇÇJç”b•!š†‘¦ëZn¡£k:uµö‘–×V7±,ÐÜÂêUã‘de$ ‚ ²•¤¬ö;è)Ñš6Ô“ºkFšÙ§ÝÈ_‰ü/©x Æ>-ð.³5´Ú¿‡5K­&ê[6g†I­åh£,ªÅ ! •È+óLU'J¤ ÷M¯¸þßÈqðÇá)b©¦£8ÆJûÚI5}õ׸–ÏÒ¼ù#ìhÌ鬥ÎkNèìô¹0ëPΨ3Ò4–órxj²=:À !(5G¥hðåc8íB&hô½>Ì4jHâ´ŒnpÔ«É¡ÕØéË‘Åmu|C;+=$:‚ºcÇ­‹³ÜØ‹DéòUªgñ¾f徆2•ª¦qTÇ[©¢t£îU{#Ÿë÷êWmŸ¹KÙš,o™ø|:’Ÿ¥È¥³Ü½ÑÄ@®ÊÊTìwQÅóës–ŸLË–±p=8bt9Ëý/ïµ›ÓOwcƒÔôð7|¼W5D{XYžm«Y¢î¬Qé3˵˜•w`UÏ*ÕÇ-MHàï‡z¤a#›¹=sVŽy³cÖ´G,Ù›!äÖˆâ¨Ê2Ö'VgÊkhžmVfÊzÖñ<ºÌ̘õ­âyU™—)­ây5™“; ®˜#ÆÄI${Ÿ„¢]+Ã1&ß:ä™Åùz›Ç|ÞaSÚâ%Ùi÷Á¹ûO`Ö]“ÑZsT÷Ý›×›U¾ÍG•4´ºë»±<Ù''šçŒOf­TcO.sÍožV"®†Ìk®œOžÅU=oàóý¿Uµ/òЏèNàOèµ÷<+9%R é£ûïÉʾ>á©Jxb!Ëox¤æTp×Cß©©ðÖä1è)ó¢Oa<–¡§Ì/a$õCüœŽœÒæ±~Æèz[rE'2éá›z—¡¶É#Œ¦z0·vû=™ÎÅÚÈ?³\¥¢5¬ô“¸µÏW¡í`rwÌ›GFº>ø‡É\/iO “žžÆÝ†‚))\Õ±w=쿇”m i#oÝ®'ˆ>–žOe±¡§[˜Ñã¾kÓç³=³õu8y–n&XT“Ö¢æg^&¼hG]ÎUÔ~÷Í^®‰ðÆg¾§êz†àÀž+Ù¡FÎçæy®b¦šlâîgœ×¢´>:¥æîÎvúãÔ7¡4éûǜ꒖-ÍrÍžö±æú¼€†ÅrTgÑa"y.¶ù.3\«Á-Ÿ"ºS¼®»³êpÐåŠgƒx’áH“•AI4x&·!wqÚš3‘æºSš´sLå§ëZ#–f\ÝëDqÌ¡'zÑu ’ÑUFCZÄáªÎ¿áOÃOãÅ/|/ÒZæ;¿jÖú{]ZYµãÙBî×& ²C™+üÊFIJ€HìÃÓö“Qî|Þq‹XL5JÒû)½íwÑ|Þ‡ö‡_P~~oþÚÿðOþÔwIñÁú½¯„~2ÛÛ´RêRZ™-/ü×`ðïÅïjžÔgÏÙ¤»E’Ú÷jFïök¨ËC>Á4Aü·mŒÛ[ ‘^mZ;Ÿo€Íi×^ã<úà ƒ\r…¢¡ˆRØÒŠPx&°”OR•dÑmd¬Ú;aP²’{Ô4uS¨Y PÑÕ’«Ô´k“«Ô4tF¡(z›)’¤Ñ¢™ z›)’ M+*†±áûX™Áò/ÎÚgp™sƒÇ~¼p1]˜ldðþîñì|îuÃxLáºËÜ­§¼µº]ºONº=¶V<îe¹Ó.žÎívʼ‚:8ìAî+Ù‹…xsÃcóJÑÄeX‡†Ä«I}ÍtiõOþ³Mv÷`ãšç;¶¥Ô؆ã§5Í(ÝI£Áõ¬eÓ¥‰ó/GqïY8ôñĹ=fâu¿™e.[Ö¡Äë…bÚ_Jƒª9M•fN5 ¿K”ÑV%óuÞsK”ÑV&¡3œ¼„š9AÖó!kÙ?¾hå'Û‘5Ó÷>R} p}jÔNy×)¼üd·j4ëÛVÌ«›Õ@~lWD)6xø¬|`ž§ïGüÿöoÿb|xøñ¢cÇ%߇|%ü€û¥ÝÚù{ècˆÿ¨á›÷ØÿA‚Àªv©QkÑvÿ‚~AÄÜS,o6 /siKù¼—÷{¾¾›þÅW¨|(P@P@P@P@P@P@P@P@P@P@P@P@P@~ÛÞ º¹ÓüñÃN¡Ód—OÔ®¢„™Är”h ¸_õ*ë*üÌ{…澇q 'FO}WËŸùy‹xÉ”ÔÄ`ðù(&©·´µ´­Ëwo…4Ö¯II%ñ3ã `Ñ©µ}Í6,cafÏCÓÛ¥u@ùüB;+CÒº"yUQ¾ŸtU½ŽE¹2v©f°Ü¶•œŽÚfŒ‘XÌô°ëSvÜt®I³èpÑ7¬‡Ì+’«>‡µ:ë@ŠójgƒJÇEhGÇPúl:;rŽ+†{ŸO†’HÓ—+ #Õ¥5bo0 žSh‘üË~Þž¿jˆ‚×Hû‹âSˆ¬¿Ò<ïµ}¡?Òf噓uê^|ŒcåP›+áóºÇ-,ž¿~ÿÏêo 3U˜äT“Ÿ4©ÞK[•û«e{AÇU7{Ÿ*Û?NkÀš?\ÃÎèèí_Á®y#ؤô; .a½yæ²gléÚ< ¥=_J;⎑²=‡B‰ Ä ç)Á6c^¢‚=wL¶S ``×TbxUê»Üì4ë=Ì£¼"yXŠÖG¦izvPex®È@ù¼V#S¦‡I¼VÊ™æÏoZi=>ZÖ4θ³\é;”Ÿ¥iìÎO­[©\è¼ýÊŸfh±ždié f“…‹†!ÍÝœž§§¬¡¾_˜V…ÏW ]Äâî4𥋠\î³OÞˆã5dC®yž¾ìó ]xzâ¨}6¡å:ÐvkŸ©ë³Èµ³õFr<“Ylo¦ŒdÏ=º;‰ô«Fg?rG5hæ›1enµ¢9*36CZDá¨Ê2Ú'VgÊÝkhžmi²šÚ(òê³6cÖ·Š<ªÒ2§nµÑyäfy/uq¬l“:Æ¥ºN9üë~eN.o¦§•ìe‹¯ <¥6¢¯µÛ¶§½É?½|š‰ýR©™4Ýy­£έTÉš^¼Öñ‰åW«¡ƒu7ºéÄùÜ]}ÎóàâßËâëÛ›;«‹{;šî[xDµˆÍbIYA¡’H£ ØäEÎYAúŽjž+^©¯Éþ‡á~1S–/!÷~ÅHÉëÒÒÏY-½vLýðÅÀh“ë_£QwGñneM©Û¡Ìc¯J›>/ \õm=†ÔÁ®è/ˆZ³´±`@®ˆž=dtVù?JÐä‘|t  ÍCgDaW5 1‰:¥CgDarU‹=ª\cF啃ڡÌê…_$žÕ<ƾÂã–Ôž¢‡P¸á2ÛcŒT9›Ç `6¥J=¥àܺ-—µ'TÒ8"Ca»øi*¦.æè94ÌŸ»I×.žUw±u4Ý dñ6;¡’ól‰âѤ 0 D±JÇMŽjZVú#“’œý+–x¤{˜l†MÝ£¡µÑXcä®:˜¯3ép™•½Ó¥´Ò0Ÿ:qÖ¸jbuÐúœKhûÈÕKkxðøW;œ¥±ëÓÂÑ¥¤¿"Ú› ¸ßÏÒ³~Ðí‹Â%k˜··VÐ3<×U*ršÔðñøÌ>MÀâµ-QNì=z”0ìø<Ó7‹¾§žêz€;°ÕìP£cólÛ2R½™ÄÝܳI¯F1QGÆÕ›«+³Ÿ¸œóTeds—óå[JReÒ¼pœ¿xW,Ùîa¢yΫ0ù®I³èp°ØòMzà*ÈsÍpÕgÕàiݤ|õ­Ïçj{AùcSø’úß­~gÇ8¨û:Xe»|Ûíee§Þ¾Lþáú+ä^/žJê‚¢½×i9INV–ׂ„o7i¦í¥ßmÚ¿8göŠ:QœR,ë´ìqÅ#½ÓHùx¤Ë=Lp6ÒBšº;í>AÅtAžV"'map«´ñ]1g‹^›ggez>^k¢2'x;Kñ'†çÜßcÕ y4o ýøf ,fŒ¬‰¸•`y¤â¤¬Ë§Rt¥Íf6ÿ¶§ü§ÆŸ³•Êx×á$ÿŒþ =»Iwrð ­CïEåkÑj¦Ø¬o ¹¨˜) R#y¸kazÄú¬·i‹â þð”ðyöš÷Œä– ðV'O³Æ±É<¨ñÌ&X¼–ÀI¸m>†/©SÞjËÌøüߌpx'ì£.yuåÖÞ».›^þGí×ìÑÿöø'û?A§ëšÍ…·Žþ(Û\5Âx¯[²Ú–„Ký’ÍžHàxÌ1²Í–˜9‰F¾Õ %: k³óLÓˆqyœšo–¢›Òþ›yu>ô®£Á ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( ⟃âÿø;Ë…îu+'KSs,‘F—KóÛ»²e‚¬É¤Àz0•Þ´*®ðëøF•G;Ë1 %ûÈ´¯t”·‹vÖÊI?–ÏcñOÃ’Í l® #¸¯ÓhÎèþÌðîi£Ö4ËŒãšîƒ>WLî,çÎÓšé‹&64#œzÖ¥O¬8Üzš9 x“óþ Wð®çÇßì+4Ì9“Ôà¯ï‰ÝÍzô©æ9…î®r×$“]ð‘Ä×swfTäMl¢yÏ]Èi= !vr:„Ýy¬dÏF„T¸ÀoZå›=Ü-3Ìõ‰þVæ¸ê3èð”õGx’ð*I–àkÏ­#ìrê7hðG˜Ïu<ÄŸ™É¯Å8Ÿ±™”ùv‡º¾[þ-¯êçú}àWK‡x/ íU1 Öi´×¿e [d鯳m¦Ýíð­‹VWγö3£´|H´u¶.¼PQÛiÒ©*3Ͻ&R=O|5%îŽÒÊà(óZÅœ5©Üé­o8ë[ÆG›V‰ÒYê@%«hÌó«aïÐÙM`ÃqZ*‡°—úÎ?õ¡ÔÁù¥ÖÿÛâ¥Ô6† ÈʺÖþCóþµœªT°ZìqZ†°XŸŸñ®yT¹ìP¨­Ž#RÕ†-úÖNGliXòmwXR]Cäš._-+Õo Ù¡&y¦©s¸°ÍQŒ™Ç\·­òf$ÍÉ­Í6fÊjÑÇ2Œ†µGFQã5¬QÁUØÌ° oy8‰ÙÒü«à½çï€:Ä{Hûˆþ"_‹ø^Cp’¾“˜ìÄ‘H®ç{¹‘Ðñ\ÄŘmUú< /gJïv~1ÅX勯û8»ÆtÝïú'Ù¦~žWió!@òWíûþÏ?´™¸Ô¼uá§øÒM¿ñXxi’ÇS8òGï_kGqû»t‰~ѾZì'5œéF{£³ ޝ…»–žßסøoñ»þ _ûI|.¸¼¿øy¯ÄÏÁo-ɻѶYj$Q#¸’ÂY ;³V8ížw/¬ê‡†¦¯‡Sêp\ENVU}×ø}ÿçcóÏÄ:‰|®^øcÆ^Õ4ÙlûN‘­YËguo½Dß Š®»‘цG*ÀŽ®)ÑkF¦ÃfTê%(Jè£Ð=ëLõiâÓ-¬þõ›Ù Aag÷¨p:a‰DÂp{Ô8›Æº$Z\¦ª±'ïK”¿oæ/Ÿî(äÖ3㸥È?¬ùŒ7<õªä2x¢ºš©S¹„ñ‰-ÏFø[ðSâ·Ç­j_ü*ø¨øšú܃q%¼j–ÖD¤ŽŸh¹¬0oJÌuÞTªå¸®ª4*Iþìð³<ÛFÅ5n‰ëå¢Õõè~°ø;þ“x+S>=øÐÚÄk+ìCÖlÓ4ݳ7™æùÆ9nüÈvmÚmü·-Ÿ8Ÿ^7ËûÇv~w‰â(ª©á)¸Áwz¿Îß{¿‘ñÅ_ø&×íyðžÞmF?ZøÛE‚Þ)¦¾ðËj Žò˜¼¥´tŽîG+1Ž@¸¶öãSÖÚžž‰©ËI>_SáýA5MTÔtMoN¹Óõ­:âKKÍ>ú‚{Iãb’E,l#«¬¬FkŽT-¹ôT3eQ&Љ¨Œu¬]ѧ™¢ÂßZ‡DéŽbŸRe¾µ.‘¼sÜö€Æ7Rö&2[\aÔ­5E™¼Å@|+ý™?h¿–ðßü3øI®êº<ðKs³qXX\¤rˆ\EyrÑÁ#‰2»ËüÇÈØÚž¥O…n/‰p¸=*ÔIöÝ÷Ù]Ÿ¤ÿàŽ¾+ºû-ßÅŸŒúfŸå߯Ÿ¥øFÂ[ßµY …¶ÝÎaòfoÞ(Í¼Š¸VùòPwÓËøÙòx®9”®°ôÞÛ·m}î¾hýø/ûþÌ¿îôo@ð1׃ <Ÿ\ÕËùø®*“»>Ÿ †TÒlòcVUÜsX3Ö‚<‡Ä¦âNêC“<›T½2犤Œ›8[é²Xæ©Éœ­Ì¹$f­#šr1åjÑ#’lÏ‘¹5¢9&Ê27ZÖ(à©"„†µ‰çÕf|­[EmYÒµoyu¤fLzÖñ<ªÒ2gl]Gˆ‘Õxv¶±7-ÁÜrÂŒ…ÌçÞ¼ül½¥N^‹úבõü3Aa0n»øª;õZ+¨þ®ú^þ†¼—y®eÚ©‰3g¹kxS<¼F-.§¦|øñWö‰ñ…Ÿƒ¾øZëQ•®"†ûWx¤]?FI°–öà)XSlR]ü²±«¾÷QÃÊnÉ/™fô°±nrùu~‡ôgûÿÁ>~~ÌM¦ø÷_ºÿ„Ÿãl– Z\5–#ïó—MŒ¢ºîG4òfGTm¢–H­F„ikÔüû1ÍjãÛŽÐíþ×Þ}ÿ¨éÚ~±§ßé½…½ö•} Û]Y^D²Ås©WŽD`C#) ©H5ЛNèò%Î.2WOt6^,ð©øoñ;ÇÞHu­4-fêÆ×ûU6\Kj²·Ùå•Cy˜ä + ¼_g«íiÆ]Ïæ~)Ëþ¥Œ­BÎÑn×ÞÝÍjz7‡nAU$ò+Ú£#ó •›=kIŸ!Nx®ø3å1P±èzl¹Û]Pgˆ‰ØÙ¿#šÞ'•UjjÙŒY:T3¢ ¶†³g\n>Õ”ŽêF”<ⱑêQ5"¹äÏZ”l”dV2g§F)šQD+ JÇ©J’‘z+PzVR¨z°‰š1Zãµa*‡§GbòZgVN¡ßO~…”²ÉéPêPÀ]ìiCi…V¨z”0VKBêÛãŒVNgtpÀ-ðá±ÐÑÏ¥†°Ü²R5£FMsÉÜö)%v6[ŒÍ8ÀŠØ‹#âèÆá®¨Sº±ábqnœ”ŒK½C¯Í]Tèž32ßS—¼ÔzüÕßN‰òxÜÏ}NJûPëóW£J‰ñ¹†e{êróÌ]‰&»á%ˆ¯ílÌ•«x£Ê­#.êMªE[Ð玬åï&95”™ÝJ¨Ü}îkžlö0ôÎT¸ûÄšå›=ì53̵›¬‡çŠã©#é0t¶<ÆzŠÞl7ÌÜ ð3lt0Z˜‰í÷¾‹®îÊýÖü=álGç˜LŸí*²³z>X¤å9Y¸ß– Råºrµ–­So ã5øUZ³­RUj;ÊM·êõgú·—à¨e˜JX,yiRŒaví¥«¶Û²I]¶ßVnÛIȬÙÚŽ†ÚNœÔ–Ž–Î|cš G[eq÷H4ŽÎÇR(©h¤ÎªÛUðw†¬¾ÇáÍ ÂßLÓí<Ç—ìöÐF±Ä›Ü–m¨Š2ıÆI'šú„”RHü*¥IUœªMÝ·wêÍÚdP@r^3ð>#ivú'Ä/h>(Ñ`¸[¸¬µ×ü­Aop°]i:œÚŒNê¢'¹†ñ¥gHÙs²)!,Á|íeÂXZrécÕ¡žc(½e̼ÏÏÁ?hM ç_¸ð|âÎÜÍb—r\iZ†¤ëc€Ç$¹“r!k‡åfhòBóOÙžÕ(JÞÒ-z_¡ó'‰?`Û;ÂïˆuoZ¬ö›<È´[û Zå·: Ùkk<³IËv!Ú¹c…RG<°S]^—adíÏ÷§þGj³ÿí¡iz–¹®|ø§hº}¼—w—÷ÞÔ ‚ÒÔ»É,TEPX± ÃR|³©û]\úóÁÿðKïÛťƟ­xGBð¤ví2ê^!×­e‚W  D¢É®$ÞC L#eÚxåõúMn0ÂE^ ËѪþÿÁu™.!½øåñrÖ Xç•dÑü L÷yCËq}rŠ"4Èm¤†òË—ÛqäâxÎm5‡§ó—ù/ó?D>ÿÁ?¿dŸ‡e¸±øA¦kšªX-Œ÷Þ.y5ŸµãaižÞrÖé34`—Š$ÆæU ¬Vºá…¥ ¢|ö'=Ì1WçªÒ½ôÓòÖÞ­Ÿ^iz^™¡éšv‰¢iÖº~§Á­¥…Œ+ 6°Æ¡R8ãPT t%mäÊNmÊNí—èP@âŸÙoömñ§ü$’x—àG€ï/õÿ´6£©ÒÛ‰'ÝæÍö´E™fbìÞr¸1Ü75œeº:)âëÒ·$Úù³äßÿÁ'ÿd_ÿeÿ`i^*ðgÙ|Ï7þ½rIþÝ»fß7íës›Nß/gßmÛ¾]¹K N]úYæ6—Ú¿ªÿ†4üÿ¯ýü/¥Üiúß…uÿÝIpÓ.¥â-væâBªJ,¼{RÀ”/—l±B¥„¤º> ÇÉû³·¢_­Î¨ÿÁ3ÿbRr~ ·þÚßÿ%Õ}Z—ò˜¼çõö¯ðÿ#«ðoìûxS¸ÕôO:ÕÔÖílÑøŠk­r…•‰X/eš5| Ã…` ÀÒ¡N:¨™TÍ1•W,ª¿Ëò>­N € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( ý¢>Û|YøwªYYéÐËãM.7¼ÐîJ¨•'\3@®]Y‚ygsl«LkŽì¿ðuÔïî½ý?àn|¯pí>#Ë*aùS«ÜU.׺ÒVåwvÙµtÉ]*êîÖi¬µ i­uYZ‹[˜Ú) ‘N¬ ‚2Å~BªœT“ÑŸÆ®xZ³£R-J-¦ž5£MthôÝ6ð:Žk¾>OFÌí,nø5Ñ=jGSo0uÖÉÜó§^ã"t|T´tBv.Ç)ãšÆQ;éU4aŸiÖ2…ÏN†!Ä׆ë§5Í*g³CkÁxGzç;žÖâjE|}kžTZŽ?ÌÑŽøŽ†±tJž`û’}´úÒöV4xöú7‡Öd'Žgæ×íÓû/_|L¶ƒâÏÃMÞ_i²ë:}¤L.uëeUº`áç…U€]»äF ˜¢¾_ˆò)c!õŒµiJG=3ä“TŽy3:WëZ$rÎE ´Hâ©"”†µHá©"Œ­ZÅ}YÒµmy•¤gJÝkx£Ì­#2f­â&¼Œ–F¸š8à¹Æ}sùWB|‘rg‘(¤+Ȥï@2]A駆”þx¸Üî†þÒi>Ý~íÏÓ‚ðG¿ë7z·í ãÛ] E’Þ)‡ü ºÔ ¼N^)®¥ÈâÓܤ˜_•Ï}, µ›>KÅiÆ„~oü¿áÜo‡ þ|!ðůƒ~x;Kðç†àÚßcÓ ùò,i›3ýù¦)a¥´´by®øÅEY#äêÖ©^\õ%vw”Ì€??n¿ ~Ô:Ö¨u´i:v±åy[>ɵËËÎã¿?aó7aÖíÇ˹¾“(©zVìÿàŸŠø‰ƒåÇ{Kßž)ú[Ýùìy/‡îþáƒ_IJGâY…-ÏhÑî~E½løÜe=OEÓn:s]pgÏâiΟ(ùI<×LYâ׉ѫZѳŽÅ”5,Ú-¡éY´uÁ—b=+)ô™©Ï#× Ñ«Ï#ؤѥɬdzTÙ³Œ•Ë6{”"¬iÄ1XHõ¨«° ç™ìaÍ(ø¬YéÓп/p+&z4¥¨¶$@8³qlíU"–ƒÅÂ/U¹kº®¡ÛȤ©ÈrÅÒ¶Å õ%\ã´(\óñ¢ŽÆDú°é]0Þ HçïurÀàñ]t°ÇÎc³že¡Ì]j„ç5ßNòx¼Ù»œíÖ¡»<×m:6>g™sN\’MvF>v¾!ÍÝ”OzÕDóêT)É&$ñZ$qÊNZýíÎ3ƒS&oF™ÆßÜ“»šç“=j4Î2þçïd×<ÙìP¦yö­uÃ’x®YÈ÷ð´¶<Ÿ_¿ ’sÅpÕªÀP»G̾)ÕMæ¢`VÌquúÿú¿~OÆ™—¶­Õúµ§N‰ßGg~èÿ@þŒ¼²Ü²·âï1§OÊœeï½%o~¤miEJ>ÎéòÌÅŠL_ S¦n[ËÐæ‚Ó7-®pÚM™¿oqÈÅ"“:+KÀ¤Ôs¥†ðm\5¹±o©íÀ-@îmCªq÷© “û`¯è‚l“ü­eKhŽwÓÐÅ›[$œ¿¬UÌ«hm??ëLW9;Ýgq#}¶s—çææ‹ÙÉßê|‘žjŒÜŽZâì±'<úÓHÉÈÆ¸›¯5iÊFD¯œÕ# HΕúÕ¤rÎE5¢G$äR•«X£‚¬ŒÉäÆkx£Ê¯RÈýuÿ‚I|ÿ„—Ç^(ý¢uÈ3¤øOÌÑt/Ÿýf¥4#í2ü²‚<«Y‚m’6Gûnå!¡ãÜ˨ïQŸ–ñ–e¤pq{êý:}ïòó? :õÏ‚€ ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( €?7l/ƒÚ†g´ø·á-+ìÖ÷÷f~eo/Ï“˜î¶*íMí¹drÀ4Áwv?QãäßÕª?OÕ—ÌüÅŽ¤¢³œ$-wj–Úïá­e}¤î“n:]¶þUÑu@ȧu}•9ŸÍ˜Ü-™èv í溣#çëѱØYÝç×Ddy5i 3nƒÅhq¸Ø¼­@)£ã­KGE9ض’ûÖN'd*—¢Ÿæ²”OB•{Ýc½c*g¥KcB+¯zÆTÏF–,½æ1Ídéž…ø±þ!øJÊÂ×ᧈ®Öôû!ådޘ˴"2Ç1ÉåË"§ÍÔ ÿ˸³!ú…O­QIR›Ùt•¶·gfÕ´[Yiï£÷‹+‹0K ̧)c°ñošZûJJI)s$½èsFR÷¥¤ù¤Üù~;·œ0×ÂÎ?«0ø…$h'ÁÖ‰êÒªoÚÝãÖMЙÑÙ_#æ¬Ú:¡3¶ÓusÜ·-‘ßiÚùÂáÿZ“U#д¯H¥O™úÐUÓÜônÛ™9úФÑ¥D>%ó×õ§ÎÉú´^æ¬>'Ç›úÕ*ŒÆXH2Ðñ"•'ÍýiûVGÔâd]ø–0dýj\Û5†æ.üNœáÿZ–Û:#Ääõ/ûÊV.èóMWÄË’øZd9ö®d-óqNÆnG-w¨uùª‘”¤r×—‰çš¤Œe#ŸšBI9«HÂR3¥~µIÓ‘BFÎkDŽIȦíZ$qT‘NFëZ¤pÔ‘Ÿ+u­¢:¬Œù­myµdgJÝkh£Ì­3&wÀ5Óxø‰Ÿ°ŸðMØSÀ?<)ãŒ?¼)uªxFiÿ²|5¦½åæž—/ÍÕæbòÚD ²Ù&)½.•Ór!ô¨Æq÷–‡Èæ•\=d¨JÍu²™úßàïØö=ð6©>¯¢ü Ю®æ­š?Ku®@²±+ì³F¯”p¡À,˜£‡§¢yµslmeiU-?+XéZV—¡izn‰¢i¶º~‹§Á­¥…Œ+°F¡R8ãPT l•´GŸ)96Û»eúP@žÿðP?‚63øt¿ô¸nÆ^‡%’ÌÚŽ$щVfÌ o—[%|ü¯ï §¡—Wtªò=™ñÜi”Çxˆ¯~žº+Ý_[õÓWÙk¦·_”~¿_5} \þnÍ(r¶{¶t6GÏ5êS‘ðØÊZ³Ò4Ë€Bà×\ó¸šg}§MÂó]1g…^e¼ÂóÍnµ<Ù®SEO42bìYª:éȹVm”æhBý9¬$NK‘KÓšÂQ=Z5M8¥Æ0k DõiU±§Áë ÀõèbMHgéÍsÊ­GhÅs´õ¬eNç¥GÊÍ»½béž”1–êY[Î:Ô:gLq¾cÅÿ'‘SìMVc¦¬µCT¨™K2ó+ÉòŸ›õ«š®c¦æEƣךé…ÅÄæ~f÷å‰ù«ª4lxó.¦T÷y®ˆÒ<ŒF;MÌ+› sƒ]p¦|ö+™,¤’s]1­g"“¿¥j‘ÃR¡UÜ’jÒ9e&Ì››Ž4›4§ œµí×^k3Ñ£Lã¯î¾÷5Ï)Å G©]`75Ï9ΑæúÅï –â¸êHú,%Qá^6×RÎÎâRÜ…_RxáfØø`0ÓÄOh­»½’ë»ÒýÕ¼?áµ™Ó[']óSìÍÖ3Ì_µZ^̯® nAhäŠºÜæ¼UáßxÛÃÚ·…|U¥A©xRˆÃsgpÙ ‚ÁVVRYC)Yâ0”±t¥B¼y¡-×Ü÷OTvåCŽáü},Ï,¬éW¤ù£%º{uºi«©E§E¸É4Ú?þ2|ñoÀ¿?†üF¿iÓ.7K¥ëpÆVJG dì‘r¡ã$•$rÊÈíøfy’WÉ«û*ºÅü2è×è×UÓÍ4ßú§ágŠ9W‰9RÇeï’¬,ªÒnò§'ÑíÍ Y¸M$¤“Ò3Œá9†p@9æ¾vq?d¡^èÓ†r0sXÊ'¥J©¯Ù ÖmШnÛêxÇ5 1¨tšÁBz‹Æw:ë/ —¥cE3«³ñF Ÿ3õ¥bÔΦdæþ´¬72úx´p<ÏÖ‰¹a|\0{úÒ°îe^x¯vq'ë@Ó9ÛÎ$ýh°swZùu9“?; Èäï5c!?7ìfäsóß“žiØÍÈĹ¼'?5RFR™$Ä“ÍZF™FI}ê’0”ÊRIœÕ¤sNe'nµ¢GæTv÷­8êL§#Ö±G Y”$nµ¬QçU‘Ÿ+ÖñG›Zf\ÏÖ·Š<šõQø ðCÆ´_Å ü,ðmÓK¨Ü#j:•½¸4]<:‰ïeÑvD­¥×{”NùÊ4ÜÌqq¡&eðƒþx?Ãþð‡ítOè–âÚÇM³$)’I$’ÎìÅäb]Ý™˜³1'ÓI%d|,ç*’r“»g]L € (  èOŠô sÂúý§Ú´-bÎk Ûo1ãó • r&ä!—*Ì2¤ž4ã'¤·FuiB½9R¨¯&Ÿ£ÑŸÌv›i«x_ZÕ|/â _²kú5äÚuõ ‘$ò.!s‰¹ VÃ)RAìHæ¾× UN*K©üß`g‡­:SVqm3Ü4KàQn+ا#ó¼m 6z–•u¹ì Ò÷9l^V¡¢£;£Ô4tBeÈåÅe(Ô«X»ýk'ºsJ+Ž5„ z”q:ã¹Æ9¬œBž*ÝM/GCXΑéÐÇ-™|^/­cìÙè,lI…ðê]xæ u,%òãïT:Lê†`»‘½ø᪕)æ =]µöªÕšY—™^MCå?5ThêsUÌ´ÜÈšûq?5tÆ•¾aÍÔÎ’ë®¶3Í«Œó3¦ºíšÞ4Ï.¾/ÌÌyK“[¨žTë9=JìõiÓ¨Uw$šÑ#–M·c*âä óRÙ¤)¶s·—ƒ²”ŽêTNRòë99¬e#Ô£JǨ^ÝÍsÊG¯BÎ S½ÎâOË9îŽÇ”ëú˜E‘™°¢¸jÌúœɤ”øOˆ~1gÅOØZÍqiqeäÉáë"<Բ̈&Y˜ºµÂ«æEm>H’O£Áὄn÷×ü9øÇg/3¯ìéÿ Û]ß~ÖíåwÖËôz»› ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( â'ÿ |Qðµï„¼[bgÓ§"H¦ˆ…šÊ`I¡rÉ'YX2³)Ûˆ©†¨ªSz¯ëSÌÍòŒ&y„–Â_z}}ÿ€ÓM§øÿñáÇŠþ x£þ¯=ŒÛ¤Óu˜P¬:” Ž@ÉÙ"åCÆI*Hå•‘Ûï²ìÆÊ|ÑÑ­×oë£?’xǃ±\7‹tk+ÂWq’ZI~}¨î¼ÓMÅ¥jªÊ¿7ìBgæØ¬+LììïÁÛóWDdxÕ¨E¥þù«hÈóªÑ: {½ÀsZ©3§cEeR<ÕY¢`ãÖ‘IØ•^“F±™(’¦Æª¡"ÉïRâk¤ÞmO)·µÍ£”j°á/½.R•a¦Z9IuNâOï üWðÿƒ¼eaö.ã±³YÌ 4.AÙ"äàà‚ +VeÆž{¹ä`‘Åj ;³¡TI ×M8¶Ï]A6Þˆþ­?a?ØÏòïÃÛ oVÓ<ÿþ$°…üCª]ˆžM7pYM·(΋ NvF>t‘‰ Ú±$^­*jšó>Œ–.£þU·ùŸyV§P@P@~7þß?„<]cñ·Á^ò¼1®f/ÿgÁˆ¬õãeܸs·ífÆ`оd@³.}Ì«ÿ.¤ýË8û"ºXúÑüVïÝúíµ¯¾¬ù@¾ÌqÜúªR?Çгhö *ñ]Pƒ]ð‘ò8ª-6zyÂŒ×T$x8ŠGoasÀ9®˜³Ä¯OS§¶¸sZ¦yõ m¤¡€5g5¬Ë ùéAiØ\Ô´k–CëY¸PªZIˆïPâu»E¤¸>µ›× K,­Á㚇ª–XmëQìÑÒ±’D‚ìžõ>ɬkî8^0èÔ{$5Ž’Ù‘µãsÏ4Õ$D±Òî@×ëT©£žxÙw+½ÛFî*Õ4sO'Ô¨ó·­h qOßR«ÎÞµ¢‚9'ˆ—r³ÈOSZ(œ³ªÞä þõV9å2”õD]³.æë¨ÍKf´éœåÕÏ^k)3¾3›ººå«Hô)R9[ëÌgšÆR=JNR¾Æïš¹§#ÚÃÑ<ëXÔ‚Ëð+’¤Ï¢Áá®Ïš¾"x¿ìñ½¼£írŽçj÷'õÅ|ogk.¢áN_½–Ýl»¿Ó»èÒgô‚žÔãÊ8¬m'õ /÷Žî<ÒµÕ8»]¶ìçk8ÃíFR…üd¯Èì¢JDë'½"Ô‹ 6:šV-H°³ûÒ±jE”¹Æ9¥b”‹+tGzV)H²·˜êh±\ÄÂôxÒ°ù…ûwûF‹0¿oàüÔX9ˆšøúÑas5éõ§asžðœüÔì'"«Ý{Ó±ewºÏz,K™U®=ê¬fæWyÏ­;êÚZ¤Œ¥2»KïM#)T+<•iò¨Wy:Õ¨œÓªS’Lw­N:•lfÍ6æ¶ŒO.½{´¿ðLߨ·T—UÒÿio‹~µ] ø7FÕ!fšY‹#&ªP¨Š¡„Õ‹™<õ $÷0^_ÞMz™ùogÊ­ðXy‰¯ý'üþîé~ëת|P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@Pš|MøEàO‹š]®›ã]#íÙù­co!†æÁÝ6³Fã·ÝbŒ6dBÊÛF:0ت¸IóÒvü™ãgyˆ0ÿWÇC™+Ù­%Õ®Ÿèî›JéØüø“àm{à·Žn|â È.”·vWÐ壳ªHS$ÆwFêPôdl\3}Þ_†.šœtî»3ùG‹¸KøÉak{É«ÆKíEÞÎÝ4ö{]Y¶éÚ°`¤?ZõáPüô;;-H05tFg[c§µÔqŒšÙLójáÍèoÁÆO5ª‘Å:64’ë8Áª¹ƒ…‹ñL2i™ÉX²„¤;wÖ•ŠSÞ•‹Uó=è°ý á!¥Ê5PBæŽPöæS°½¡ç?þøâ΃>ƒãM ¡åI¶ ¨‚ïNg*KÛÊA1¶cŒ>VÚ†\©óó« šÑtqPºèú¯4ú=“Ù¦´>¿ƒ8û>à Æ–Gˆpi§(]û:‰]rÔ‚iMZRKíFîP”ei/Æ?³ÿŽ~^Ú>¸ðj^¾•ã²×,„nÀ¶ØæR?u1E³,¤nÚï±ñø–ÃX¬’IÔ÷©Ëi-½gmmªìÝ¿Ô ñTN¿ ÞIerH©)Sò˘ªÍ‹¶Db£r:¶0kí0˜…V K©üÇÄ9EL&tj-bíëæ¼žëÈôMPû€µz´æ|6†ç¦éל/5Û 5ˆ£¹ÜXÞýÞk¦2aÞ~?Š•‡ÌûTX9ÃÏãïQ`æÓõæ…ÌFf¢Äó‘4ÞôìK‘ —Þ‰r#i=騇"“ÞŒÜÈZOJi¹4žõIÊ¡ IV‘„ªžQV¢sN©Yå÷«Q9jV±›5ÀçŠÞ0<ºø”ºŸ¯ßðOßø'ññ÷ö'ÇŽú'üP%߇|%}ü‡{¥ÝÚùsècˆÿ¯á›÷8ÆÞTZtGæüIÄ®7Âa%ï}©.žKÏ»éë·ô^¹ùàP@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@yŃþøÁ¤[é^6ÒZy-<Ö±Ôm¤0ÜØHé´¼Rø pѳ"FÚ1чÅUÂËš“·êyÎEϨ{ u>d¯g³‹j×OôwM¥tì~YüVýŸ¾ üóµ+¶÷còWþ;H„")$ÈÙ5¾öh¾q€Ùd;ãƒ6Áö9voOh='ÛüŸôÿ3ù·Œ|:Æä<ØŠ¼¡§¾•¬ßIFí­t¾±wZÝØó]3[G VJ÷aPü£‚ktvöšª05tÆg‹W ÑÑ[jàfµR<ú” Û{솭TŽ*”Mh/ºdÕ©³¢jGzzµ#žTYm.î*¹ŒÜ')¢è›1Â@z ?p¢ÁpÜ=h°\a•GzfÆù£µ!Ø¥}me©YÝéÚ¤7z}ÜOö·1¬‘Ï¬Ž¤ÊA ƒÁ¦pX¸M^/Fž©§Ñ££ ‰¯‚¯ NnH5(Ê-ÆQ”]Ô¢Õši¤ÓZ§ª?$?hÙ+ZøvÚÿŽþí‡pââ]3{Éy¤¡Üd8 ù¶ñáNýÛÕ[ç#Ê!âN ©çÅà½ê+Wµþ±]ït·ºNGú-à§Ò[ Å?Váþ'~Ë1—»–J•f¬¢´k’¬îýÞUNR^㌧ KãHnò ‘ë_ŸJì*Å%¹£Æ{Ö¥OrÒOèjNÈW¹ag¨q7beœúÔò›*¤‚sêir–ªŽóýè°ý¨¾¸¥Ê?jÆùþôì'PC9÷¢ÄûB&”Ó±.¡“Þ©#)T"2U(˜Ê©IïT‘„ª4•ió¨Vi=*ÔNiÕ*¼žõ¢G%J…9$ëZ(œ5*”%—¯5´byÕkØÙjzæ§§hš&u¨kZ„ñÚÚXXÂÓÏu<Œ"Š5ÙˆUP $€k¢ocÉÄâ£å'd~õÁ=?àš¯‚5_ ~ПtëTñ ۽·àMJÉš}rÑ5½ýË —*¢m¶íŒ‘¹dš=‘út0üžô…Íso¬^§WßËÓúØý±®³ç€ ( € ( € üÔÿ‚…üÔ¼A£ø{ãW…tÛ‹½WÑ5†¹²´ý——•./€HÒnÙb·,ìBC‘êåxŸe?g'£üÏ€ãÌ‘ãðËJ7”¿—{üö]nôGæo‡õ0耷Ì;f¾º”îçcy¼×Tdx5è}•ö6äþu¼dy¨-µæqÍl¤yÕ(ØÞ·¼#5¢‘Å:F´7yêkDîsJ‹Ë(>Ôô3Õ¢ÃRº•ŠS$>´¬Z¨Çy¾ô¹KöÂù´rUKK”~Øi–Ÿ).¨Ã'½;ê.i؇P‰¤QÔÓ"í5ÌkÞ‹¤5ÊS^®*\#I˜Óßuæ³r:áDŸ¾<óY¹p¢`Ý^uæ³”ŽêTNbòÿÃV2‘éÑ rw·ýrÕ„¦z”h>©©…Wù°+šs=¼.¶ñ_Š­tÛ[‹™ç K^^3O NUjÊÑGÝðïã3¼e,“ZŽÊ+¯è’Z¶ì’M¶’løÿÄ>#¹ñ£%ä®âÄ11û‹þ'©ÿë ü‡8̧šbG~Eð§Ñ›Ýý×i#ýðã‚ðÜ “È–µgýùkew¯,åŽËyr©JF0“Þ¼‹¡ª„¢J—UPIïJÆŠ¡(–•É£Ö•‹U ¾ô¬Z˜ñ-+œQ/¹¢Å)ó½éX~ÐO7ÜÑa{@ó¸ëEƒÚ 2Ó±. Ã-; Ú´ÞôìC¨Fe§bB6—ÞŒåP„È*¹L¥T‰¥¦¢e*¤--Z‰„ª•ÞozµšuŠ’MŽõ¢‰ÇR½„±´Ôµ½KNÑt]>ëPÖ5 ãµ´°±…¦šêi*Gj ;³0P IVЦäì‘æbq±¥)»%Ôýõý?à™Zw€._âí-¥h^#ñ4°*é¾ u]BÃLD<Ǽ¾]ÅÊ–xÂ.øSiuiY£h½Ì6 S÷ªjÏËs¾'ž3÷8Fã¯fý;/Åí¦·ýƒ¯@ù € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € (  ·Ö6Z•曩YÁw§]Äð\ZÜÆ²GdÚ†,Ê«Ø8RæKHÉâlä&]\¨Y[l_I–ç<©RÄ?Gþç÷ùþ'ƾº³–7'§tîåMtëx.ÏùV©éÓ´~%Ò|J“"PAîõTë&~ŠË\Ðïlµ¾Oã]Q¨xU°]ŽšÛV=m‡›W änêg5h¦qO jC©c½h¦rÏiG©ïU)œòòÚj#Ö©LÉÐ- Dz«œÉÐ$€þýâö#ÿ´÷¨æ°cMòzÑÌ?bÄ7ê;ÑÌÅ5ÿ¡¥ÎZ @×þô¹‹TO‡þ)þÆþñ3^ëî¿á×_|†Ã]>w>ccgÞƒs² ÆJ"&"káó~ Áã/Sýœûo¿Mã­¶Ñ%¤Oê_>“|EÃ~ÏÄ1úîYsiñ^ê¿7ÃVÑRvšSœåyVHüÿñ÷Âï|-¼khRÁdÒypj°~öÒäåÂì”p„lÂ7Û&ÞJŠüÓ4ȱ¹T­ˆ†$µ‹ß¯¯ggmÑý½À¾+p×ÑSÉñIÔµåJ^íXiÞV¢ä¢çjnZFláã¹kÅ”Óéb“êZYýë7®‚ÂÏïPàtÇJ&÷©å6U‡ ½ér”«óhå)V7ÞŽQ:£|Ïz|¤ûQ¦Oz9IuHŒ¢©DÊUHŒžõJ&.©KT¢e*¥g—Þ­Dåb³Ê+E’uН0õ«Q9*WFtÓã<ÖñæÖÄXö?³¯ÅÿÚ_Å^øM៷›!õ=Vîe·²Ò!–AÉq3ÀØFåuŠBˆût¨J£ÐùìÃ5¥…æõ躳úhý—?a_‚ß²õ¤Zžcÿ 7Ä—ò䛯Zõ´/sm'a‘l/ú$/æNJ«4Œ²í’YB¦ßRÒÛsá1¹lk÷Ý£Ù~½Ï´kS€( € ( € ( €)ê:vŸ«é÷ÚN­co{¥ÞÂö÷6wq,±\DêUã‘ÊÊH*A 4ÚwDΩ «§£OfÄ/Ú‹öVÔþê’øÛÀðÜ^ü¼˜ ifðì®ØX&c’Ð!b˜’rDrÛ_¤Ë³kû¹ü_Ÿõýy~)Æ|ð7ÅáUè½ÿºüüŸGòzÙ¿ѵU‘ƒçé_CNgãxÌ+‹jǦ麒•P[ší„ÏšÄášggg|5tFGZ…ŽšÒ÷‘óVÑ‘æÕ¢tv÷ªqÍl¤yÕ(³^¾œÕ©“¤jÅw>jµ#žT‹ésÇZ«˜¸} zÓ'”pŸ4””L^”Ðã0í@’c<áëAVn0h-Äû@þõòµÏ½+”©”äº<ŒÒr5TÌùnÇ<Ô9F‘Ÿ5àÁùª\áHĹ¾85›‘ÛN‡=÷SšÍÈí§DçîïÀÏÍXÊG}*#}©˜øÖ™ëPÃ^¥ª„ —ýkžs=œ6¾‡xÃÆvzU¬÷7W!!Œg“Éö¹¯/Œ§‡ƒ©QÚ(ûŽáÌ^sЧƒÁÓs©7d—ëÑ$µmè’mèüMãïÞ4³1K$lÅož¹õ?Ë·|þ]œfµsJšé²ý_ŸåÓ«Þžð°—§Šš÷ê~<¾ª ï³›IËhÆ<úËšñOÓãT™d÷¨q:#T˜IRÑ´j’‡÷©hÕT•AâOzV-T•‹UïJÅ{AÂCëEŠUó­pó=è°{@2{Ñ`u=騇Pi’ŽR]A†Jv!Ô#2{ÕXÍÔ#2ZiJ¡KT¢c*¤-(õ«Q1dVi½êÔNY×*Kr<Ö‘…Î*¸¥§Úß³×ìûA~Ð_ÙzâèŸð‡ü9ºòåÿ„ŸÄѼ?i¼—ßgkþ¶ãt3ù‘¾ØËç)¯B†u5z#ä³N(Âàï¾yö_=ÞËU¯UØýÿý˜¿cß„¿²î‹ðžý£ñîÁ,õ_ûN£‡20Ž2̶З#÷Qã+^cJñ‡¯^Ž»¿só¬Ï7Äæ“½WhÞê=ù¿7çk-«ksÊ ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( €>eø¯û(|*øž÷Ú¼qðߌgß!Ö´DXÄò·˜Û®`ÿW6d—{¶WÚ˜z\ʾÉ;dzý;~^GÇçü•gÊS”=Wz:]ëñ-¥«»zIÚÜÈüêøŸû?üTø?|ÿhÒîõ>c'A“-ïûTùˆtIEèõ§ÌO±ÞZ9ƒØ7Àw£˜~Àc_ÍK˜¥@ª×Ý·Tó*v¾ÿj—1ª `ëVúF»§ÜiZæ›i¨ésíólï¡Iâ“k‘ @5hS¯N¬T¢ú5u÷3ÒËqXÌ«^´©Uí8IÆJé§iE¦®›NÏTÚØùsÇŸ²çÃO$×>Y|1«¼)–È´öî]ÔÖìØU0U‰£UÝЀ¾S1῜¨¯g.ëU«þVþäšµü¬~ýÁ¿HŽ.áÙF–g% ’V£Q(Å¥j±ÛnÎr©Ž\»¦Ü‰)R¬Ú²ªÕ9·&ãیܭ¢§)µx©Y»`—Šz5x.“?X§‹êZ[ {Ön™×R}IÇ¿¹ V$xŸÞ—!¢Ä3ûÒäÄ óéò’ë3Z9Dñm7½R‰”«´ýj”Le\…§÷«P9åˆ+<øïV sN½Šr\ÞµŒ¸›u=›áìßñçö€û|Ÿ~jšý–õŸS ’Hž^è~×pñÂfh›ÉæmmÛv‚GM<<ç²<,nsC ¥IëÛw÷°ßàÓ­ìõÚÇ×ZÞ²—L|=àù ®ž%rñMu,~|é,b,˜ÖÙãÌYŽ×ôðqÄÏ“ÆqZ·T#eÝïþKñ?`<à?|1ð~àèº/„4[qmc¦Ùƒ²$É$’IgvbÎò1.îÌÌY˜“Ø’Š²>v¥IU“œÝÛ:ÚdP@P@P@sž.ð†¼{á­cÁþ0ÑíõO ê˜.¬nAÛ"äAe`¬®¤2²«)  Êœ”¢ìÑŽ#KJTkGš2ѧý~=7GàÅ¿€¿g]\Áâ›O¶ø>âñít¿Zmû>¡…¡Ð1h%*Oîäêc“cH¨\ý^  êÉëØþ~âŽÄerrœoM»)-Ÿ]{?'ÙÚé\æô`H ^Í:—?5Åàùo¡èšvª0 šëŒÏŸÄa{u®¢8Ãq]™äÕÃ%® 8ËV±™çUÛð_Ž>jÕLàjÅ~9­ŽYP4b¿ãïf©Hç•Úßúš®c7D°—ý5#7DŸí©Ž´ùˆö,O¶¯­Áì€^'­ÃöLcÞ èi9 ReV¿´¹Ô<Òæ-P3¦Ô3žjŽˆP3e¾ëóT¹ eϨÍY¹Tðæ Τ9æ³s;©áÌOï|Õ“™ÝO r×ú®sXJg©C pÚ–³´12`W4êÞ}‘¡ð¿áoÄ/¾%½ðÇÃû[ô8L÷º®¢ï‚Û²*± ì¥QYŽãj;/—‹ÇCËî>ó‡8WœU䢬–­½—kï«è¿DÚç?k?ø'íà)­|Gài®¾(ø3Êó.#ðþ™ö{í.c*Æ©ö,²Ü+FD\ŒL]"E ÿ ™ÕÄc¥y?w¢íþðûÕ< Ê8^Ÿ%(Z³IJ£Þ]}"¯ÑZöÜš¹ù‡m©hšž£¢kz}ÖŸ¬éóÉiya{ A=¬ñ±GŽXØGVJ°A¯Ÿ'f~»‡ÇƤT¢î˜Gsž†±p=:x«ìËi=fàvCN³ûÔ8®L³T¸›Æ¹(˜zÔòšªä‚aëK”ÑV%µ<¦Š²æûÑÊW¶Í¥Ê5X_4zÑÊW¶Í£”Ÿm`ó©ò‡¶e§ÊC¬4ÍŽôr’ë‘™½ê¹Lr#8õ§Èdñ…§«P0– ®:óT sËb¬—XÏ5¤iœuqvê}]ðSö"ý¥¾<\ZKá¯]h~¸‚+¤ñG‹ã—LÓä†XžHd…™ —(á o y‘–*¬»i`ªTéd|Þ?‰p˜K§>ivZ¿ò_6Û€_ðL?ÙÿáƒYñÝ¿ü,ϦïôÚ¢i°çÎ_ÝiÛ1ʾÐÓáâWÊHö[ýÿånÎçéuŸ>P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@|ñÛöIðÅ(ïüGá3†¾!ˆ¥xîmcX¬õ9ÙüÍ×±ªÌÄÈ É‡ýææóB*W§ƒÌêáZ‹wåéþ_‘ðüKÀ¹~}V§N½ž©$¤Û¿¾’Õïï-u»æ²GçwŽÿg ­ïõÂÇQðå– šæ/Û "2¼Œ€ £¸i$낤ý7¡Y¨©YöÕÅs¿³L²2«*\ô×ÚŽ«k·o‰%­ÛI~ò«/,Чx ÷½xÖ?=­–¸»Xé-¼@0õ´jžu\‘µ¹œ|Õ¢¨qÏhG¬ÿµTªòÁ—Xµ^ÐÉá F¬z~З„u`EäýToö·½ãú¨ÆÕIÍ.r–ªú¡þ÷ëIÌÑaŠ’j¿íT¹›G R—T'<Ô¹›G eͪ7?5C™Ó *2§ÕO9zÍÌë†Èñïü9øoâKŸ¶ê¾²kÍòJóÚîµyÈ,ÒŠ™ #9lœ“êsäb²œ.\Õi+ëªÑ»÷µ¯ó?FÈ|AâÞ¥ì0„Ô-£+TQQVJ*¢’‚KKFÊÖ¾Êß;x—ö´^_ x’@ÊŠ¶¬¡·¾ï˜™chÛÐyg‘מ>_ÂTí|5KyKüÖßs?uáï¤&15 亂~õ&ÓJÚ.I·Ìï»ö‘V{]käºçÃè!¤kX¯ U ÒiÒy˜$ãOC‘ƒ×ƒÃØÌ6¼ªKûºþ?¹¬ä~0ðætÔYP›m%Urì¯~då·JòMµkj¯‡sáØxtx¾ûºͷ„÷ögöÜö%§Û<¿7ìþy]žo– ùyÝ·œcšòªa*ÒÒpkÕ4}õ|."÷d¥ù7ÝòÞ#ƱtšèzqÇB[1MÐìÔ½˜Þ-wn×» ¯fÈxÈ÷nÓûÔ{6CÆÇ¹ÒxGÁÞ8ø‰ªO¢|>ðf»â}j vº—Oðö>¡¹ð_ü¯âŽ£ý©ÿ ãG…ô-ž_ؿ᰹ּüîó<ß8Úy[qݾfíÍ»FîˆàÚg_‹"ÿ…M¿WoÊçÞ¿?à˜³OÂ[›=sÄÚ]×ÄOGo¼¾0X¥Óâ˜DñÌðØ*ˆÊHd,àÜöFUƒ)v꧆§—<,^w‹Å]_•yo÷ÿ•Ñšèn+¦3Ò Ó<9¦B!µ²·lk’I$’Y™‰fv%™˜³I'ÀœåRNRwlýs †¥ƒ¥#Ëè’þ¾÷»z½N†¤ÜñŠÿ³¯ÀïŽ0MÅ_†¿w%¼V£UžßÉÔ!‚9LÉW±¸‰–%RE{‚v'N3ø‘Ó‡ÆW»ћ_—ݱùEñSþÝaöy¯~|^ºŠê8"XôÀ²­ÄÞió¯­QLIåµ´„ºrà>SЦ/ágÒá8®­7jð¿šÿ'¿Þ€¾*Á>¿k/„÷†7^,Ñ„ñ[C«x¶®—ñ È¢épÈÏ$×È[ަ ¤6Wô>—Äø:öN|¯ûÚ~;~'Ǻ®£¢jzމ­i÷:~³§Ï%­Ý…ô- Ö³FÅ^9#`X*@ ‚5É*M;4},t*%(Êé‘-Àõ¬ÜÈb‘8œõBÄ"A0õ©å5UÑ ˜zÒå4UÅó‡­.R•qâoz9JUÃÎ÷£”q<ïz9CÛˆfõ4r‰×g´ùLÝq†qëUÈCÄ"¹µJÄ¢ºQœ°ÅR¦ÙÏ<\c»>‡øyû%þÓŸ¾Ë'‚> ø¢âÂîÁu;mOSµþʲ»¶m›»³2î#(G%”–ª’:¡ƒ©=¢x˜®"ÁaôUÛM_Ü®}ýð“þ ñ[þÏÕ>5|GÒü5`ÿc¸“CðäGR½hÛ-qo,ï²ymE’1sbÇæUû)åÏy³æñœexá Û×W¢òvݯ¸ýXøGû~ÌΟyá_…šeïˆí~Ç*øƒÄ€ê·¢æÛ&;˜šmÉm1r]²D !@D ßONŸÂ”ÅçÜk~Ö£³¾‹EgÓMþw>®­0( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ù{â7ìðWâF«¨x†çJÔ4?jbòóSðýÙ…®Ÿi )ä‡fXóŲͻ¾†eˆÃ¥»¥ÑÿW>K6àœ£7œªÕ¦ã9;¹EÙ¿“¼uÝ´®Þ·Õßä¯þÁ^:ѾÕ}ð߯6:íšý¦eÓ5…6WA˜aŽUݲ0Ê—!7x vzÔ3ØíV6ó_×ùŸžæ¾UWž_YIjùd¬ü’jé·µß*¿áó޳ð_ãÇ…¯¡Óu„Þ&’âH„Áô›3ªD–\m¼Ä •?!`À`‘‚ õif¸i«©¯žŸ™ðXÞΰ²å–Mïî®e÷ÆêþW¹å¶Þ'†A”HöjïU“ê|•L¶QÝ0øþZ ÖŠ©É<] k®§÷ÅWµ1xØuÄ?Æ)ûB öµ•þø£Ú `ßb3¬¯÷é{Bþ¦ûɬ¡ç}¡Kû%ÖgçC¨oìgË®Æ?ŒT:§Dp/±s¯Æ2|Á­Dªtð ô9Û¯B™ýàüëVG£K-“èeXjZljµkoø_GÔ5zëÙôÝ*ÚK«‰ö©vÙÍ…VcÀRz 穊Œäì{<†¾&j å'Ñ+³ê/þôWÄ#i{®éö Ðfû,¦O¾éà—%Ú;Hw0–5Á1N`;˜.AÜWË­›SŽ‘ÕŸy–xŒ­iWµ8é¾ö~KªìíùŸ|üý~ü91j¾6ÝñÅ+»÷Ú岦Ÿ|Õý݆æFÌr >{MóÆ<³Åy5³ ÕtNËËüÏÐ2Î˲ûJqö’ï%§_³·ß~êÇÛzv§èú}†“¤Ø[ÙiVP¥µ­•¤KVÑ"…HãE*ª€€\M¶îϨŒc¨ÅY-ÍWJÓ5Ý3QÑ5½:×Pѵ$µ»°¾…f†ê«Ç$l º2’¥H ‚A¤ÕôeÆN-J.Í1ÿ ·û2ÿѺ|0ÿÂGMÿã5Ÿ²§ü«î:¾¿‹ÿŸ²ÿÀŸù›Þø ð/ÁzÝ—‰¼ð_Àš‰,÷ý›UѼ9cgso½d±Æw#²œUˆ<MS„]ÒDOˆ«Ô“O£mž±Vs…P@P@P@P@P@P@~Ñ_±?…¼S¢^xŸàžƒcáïZ~ûûÌ‹ka|•"+ip€£ Df-æ}ÿ6?S™T£%Žñü‚â^Âft¥W «¢Ò2ò¶ÉöjÊ÷¾÷_“rßk>Õ.4h×ú>»m³ÏÓu[i-gƒr‡]ñ¸ ¹VV†½}ELf¯t~˜äu°³têÁÆK£Vs:«yiY? ×djÜùÊø·G]k¬© wó]¨y5pm=è5d |ÜÖª¡Ã<#5¡Õãæ«S9'†h¼º=ê¹Ì²šõªç3xrÈÔTŒî§ÎfðìiÔWûß­áõv'ö’ÿ{õ£œVc$Ô—z—9Qò›êC'æ©s6ލú˜çšNf« eÜj gæ¬ÜΚxS}]Frõ›¨vÃßC ï[@ÏYÊ©ÛKßCŒÔ|Fˆçü«šug—7ÐõŸ‚ß³ïÅ?·BëC³þÅðRìy|O«Ã*ÛÌžiÖÐþ“*ì”íRö¼‘–\ùX¼ÎžMßoó?@áîÅæíNÜ”ÿ™§g­½Þï~ËK6´?Uþ~É_ > ]YxŽÚ;{âP´gÄZ£s xÑ%Ð’%_ï”,®†VRE|æ'W¤—cöl…pS¥jŸÌ÷ó²Ù/½Ùµv}E\gÒ…P@y¯Ä¯ƒ ~1éƒHø£ðûBñ5¬v÷ÖòjÖQË=ŠNª²›iñæ[»Ož&G‚ ©(FzI\ÚŽ"®óR“‹ògÀß?à’¿³оÕuà‹¿øüX5½­¾™¨BÉn~r—Gv$šNYF“Ƭ±€61.y烥-´=Œ?ãhi&¤¼÷ü-ù3ä_Á|a¥ÛËðû㦃­ë&áV[_èóèð¤[.³E%Ó3†À!˜îB·<²þÌö(ñ{½ªSiy;þ‹ó>qñ‡üïöÅðÆ©Ÿ¢øGBñu¤–ë3j^×­¢‚',ÀÄÂõ­äÞ†$!L:á‰Ü `&¶Ôôèñfjòn>©þ—>qÔÿeŸÚ‹GÔõ"ïöxø%ÕÄ–ÒÉeá»Û¸YÑŠ“ñFÑÊ„ƒ‡™`© ƒX¼%Dþztø‡ (¦ªÇïKó)Ù«öšÿ£uøŸÿ„†¥ÿÆj~©?åqªÏðŸóú?øÿ3Ê|K¢ø—ÁzÝ÷†|eáíOAñ%–Ï´éZͤ¶w6ûÑdMñH—r:0ÈVpEg*‹³G]<ÖXóÂI®éÜõøf¿Úgþ×âwþ:—ÿ«ú¥OåqÍý¿„ÿŸÑÿÀ—ù‡ü3_í5ÿFëñ?ÿ KÿŒÓú¥OåpŸa?çôð%þg£x?öý°üw¦O«èŸ5ëkXnÙ£ñ ¶ÚÅ«°^Ë Œ˜q‡ PÀU€¸àªKTŽZÜOƒ¤ìê/•ßâ®}á¿ø$Ïí[¯h–Z¶©¨x×óïó4mkXžK›m®Ê7µ­¼ÐÀ%ng •G.›ZØóªñŽ2j*OÍ%oŧø@xþ׬Ïo ^|Løékkt' ªhþÑÚá)Ê[ßM"í;ÛŽÇå.[XeÉ|Ló«ñŒÝÕ*~¿Í/ó>ÉðüÏöAðÖ™=†¹á]{Å×R\4Ë©xƒ^¹†hª‹#oÀT°% åÛ,Fн1ÁÑKž=n$Ìj»©òù$¿[³í¯|.øgðÛûOþ×ï x[ûGËûgü#šE¶ö¿/w—æù(»öù·vq½±Ô×Da|*Ç[[om7+wmþguTbP@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@Pão†Þøb4ÿxCJÖáHf‚/í•åµY@Y ýøX…_ž6VT‚ ‚4§Z¥zrhãÆeØLƘºQš×t¯½žëÕYŸ-x‡öø¬jÞi)ðí²B#6>¨%ŠF ÇÌcuÒn €áp£ Iî†m‰‚³iúÿÀ±ò˜¯²LL¹£ CÊ/ñ÷”Ÿão#çOÁ;> Xið?„~-hú¾¦f $Æ›6™ŵ²Ë$opKnØ6”‚Ná€t3Í}øýÏþùlW…‹–øzé¾Ò•½S—åó<ÏÄ¿°ïí' XCy¥Åáß\<Â&±ÑuS±©V>a7QÀ›AP8rÙa…#$tC:£'guýy\ññæ4£ÍI¾Éëëï(¯Æç Ÿ²_íV~ÿÂÙýÆô³ÿ·5ªÍðÿÍø?ò<ùxs›ô ¿ð(òEmKöUý¨tÍ>ûR¸ø]vöö¼ò%¦¥as+*©b(çg‘°8DRÌp$T³l;vSüù/sŠqrx}iEþ W~‹S3Bý˜¿ißé6ºÖ›ðŸSŠÎç~ÈõK»M:qµŠö÷Ç*r§”da†A©f´"ìçù•G€3jÐS 'ÝÅ?¹´×Ü]“öAý«|*rì9¥ÿòMCͰÿÍø?ò:cáön·£ÿ“Cÿ’:_~ÁŸ´·ˆ´ùï5(<5á«”˜Ä¶:æª^Y*‘ 6‘ΛIb¸,(r `œ'›ÒOK¿ëÌõ0¾ãêGš§,<›»ÿÉS_‰ô‡‡àš:„ÒøÏâö­©éF±ÛèºdZlË.åÃd’áJí ì’á‚óŠ{±·ãþGÓa¼9ÂS•ëÖr^IG_WÍù|ÏWð×üÏösÑ?´·eâ/ žX×5w‡ì›wgËûƒ;· ïÝ÷6üÙæžc^}méÿ緅༧ {ÁÏüOoü—ñ¹ö…üáXM¥x/º>¥Í1¹’ÏD±†Ê)%*ªddT*ˆ7œ(…qJr›¼Ï¥£‡£†%(®É$¿¤©6 ( € ( € ( € ( € ( € ( € ( € ( <ø‹ð›áÇÅ­.-#â'„l5«XsäK:´sÚå‘›É Ëã{¶2î †Èâµ¥Z¥znÇ;-ÂfPöxºjkÏuèÖ«mlõê~SüKý€þ+øCP7_ ¯àñŸ‡f›lvwSCa¨Y©ió Œ°Êª‹2+£3¿*‚kÝÃfðjÕt×õúŸ”g^â#.lS‹èìšß½“¶šÝ6ßÂ|sus«øwTºÐ|G¥_éí®Ï?MÕm¤µ¸ƒr‡]ñ8 ¹VV†¡¯n–"5âîËñù5|%GN¼dº5gøšöºêœeÿZéSÅ«}ކßXJ?:ÕT<ú˜Kt5SWn>zµPå–v-¦®¿Uí ¥„ò-.¬q÷ª½¡“ÂÕMÔ{@ú ßíoö¿Z9Çõ_"'ÕŽ>ý'2£…]ŠêÌ3óÔ:‡Dp‹±BM`óûßÖ¥Ô7ŽÈƺ֑s™?ZÎUÊX6ú¥ÿ‰à„9i”É$ô¬%Y#Õ¡–Êz${Ç‚¿eŸÚ#â4Ê-| s i¦i “Qñní5 e~L. Ã#eT:D˸ã#kó+æ´)ý«¿-à~'Üe|šcn—³yû¿‡ÅóI«üÏѯ„ß°¿Â?µ?!ñ߉W?½Ö­Õl"Ïš¿%ŽY)"ƒç4¿4aÓËêòÿ?øcõlŸ‚2ܮӪ½¬ûÉi×hê¶}oªº±öµyÇÙP@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@P@Ïx—Â>ñŒ:gŒ<1¤ëºl3 ˆí5›(¯"ŽP¬¡Õ$Rw€ÎŽæª•7x;?# F†.ÏMN;ÚI5F|oâÿø'ßÁMkÏŸÂWÞ ð¥Ð³hmಽûm¨Ÿæ+4©pWå”2,È  i%£K5ÄCâ³þ¼ŽÇx”bîé)SvÒÎêýÚwoÑ5òÜùóÄðNÿˆúqÓÿáø™ jû·ý¨ë6“é~N6ìòü¿´oÎ_9Ù£²v÷ÓÏÛ‹ùkþGÉã<-©§Õ«Æ]ù“¥­ÍÃæ|ëâÙÓö𞥬|$Ö¤‚Y„= Õ¥ U˜ŠÑåp¸SórÀBžk‡žŠ~Ÿ™ñø®Î0Ñæ–µýÖ¤þè¶þv±æþ!Ñ~ x. WÆ^ñ&ƒ¦K0·Žó[Ònl¢yJ³*(,U…Îp¤ö5Ó u)»FIüÏÂøì,yëДV×qi_æsPø¾Õ¸)Ÿ÷…l«®ç—<¦¢û#›Å–íÂþ,)ût%•OùHOŒ-ü¼§ýô){uܵ”Ôd½¤jz—‰õ;]Ãmî±®\îò4í.Ýî§›j—m‘Æ 6YŽIè*'Š„ä쎌>C‰ÄTTéSr“Ù$Ûû`ÐgOÚCŶê:?ÂMj+xæ0Ö &RÀ+dEw$Nˆ8R¤ä@⩚áàìç÷kùM„à ßxÐizÑtš3Ü|1û|gÕçÑæñWŠ|5 éw0‰nÒ &¿¼±caˆ"DìÅgÚ>b¬ø¸êgtÕù"ßáý}ÇÒá<.ÅÍÅâ*Æ ïkÉ­6¶‰ë£÷­ÚçÐ~ÿ‚yü8Ò'Žóâ‹uMÒ0²·_ì«9bhöªH¨Ï1erϹ&@p ®nà­œV©¤/ãý}ÇÖe¾å¸F¥‰“ªÿð÷&ߟÅòïöw‚>øᵉÓüàý'CᆠŸO¶T–ébR±™åÆù˜ožFf%˜’K|Ú•gUÞrlûl_…ËãÉ…¤ ´ÙZöÚïwêîÎÞ³;€ ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( €9ßxCÂ^5°‡Jñ—…ô{LŠaqž³eäI(VPá$V‚» ØÎŽæª3”âìa_ GJðS[Ù¤Õþg;¡| øMá}V×]ðÏÂÿ iå®ï#QÓ4KKiáÜ¥dˆ—*̧Ät5R­RjÒ“kÔÆŽ[‚ÃÍT£B’ꢓûÒ=³;B€ ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ( € ÿÙ endstream endobj 69 0 obj << /Length 2757 /Filter /FlateDecode >> stream xÚ¥YKsÜ8¾ûWômÔUn†/IÔlí!™$S™™ÚIÖ½µ[•ø «é¶*j©£Gç×/@j©­q²›“(AòÀâ«ýН~½àþùb{ñìu¯2–%2YmoW‚'LÅñ*É8Ë”\mw«÷Ñó|½Q*‹ŽM×oŽmSØ®+ë=5ú¦©`Œ`ëëíoÏ^‹l¦P3ÁS˜Î©ê‡ö¦Áa¯¶Ÿ.ÈùJ¬¤J™Ô¦LÀ´Åáâý5_í ó·g*3«{7ô°R0À@«Z]]¼£Ì&”ƧÙ|U^_›Ž}! gKŽ9Ó±m{Û´‡Ž–›Óÿ ÏIÖÚbh»²©éµohLsÓçeÝYš(›mEš1Ë0Ó.ô’9Œ'"Œ¹\P“0žé‰’xQ‰Ìf:Ve8ã0h#Ëà„]_^ïèk#¦†&̤Iøþë‚~I‡EãW›š©ÅÌɰ3YÐc˜T㘢´uß]®72æÑ«O£¢OIÄ×åDO¸ŠSO2鹿++»„ÊX3e’o R)éÖàÁ¥é R©ÚT–*7mw´E߇eXj–f*X8t¶£%¶:KÍå¦Uú¿o¼Wßx¸èŒq#çp)òªª¼·£)Ô86UÞ–_ó›²*û(7]Ó{ç'øN‹Í—8[ fR0c:9‘íË—¯·K[3¥ÇûËÑ1yåUkóݾÄѵ5µº¡@¶ºªêÁ<«Òî¨Ûù/?¯eÁ*š¡óß=t½= •äQ›×{"<èºm›}ÕÁŠ X¢Û³ìâÙ|Ëê¼nŠjU-î0×Ñ{­.©¥õ5¶„rF äx×@SÄh PJ”RP·&¨ˆƒŠ$4Òkô—LGoj’ôw¥ÞÁÎÓ9À˽¥çÎvE[ÞØ0Ø7¦Û€‹âghǦ&¸(-£æ–ž#ãÍÀnt6ó²'Î4#7vÍm¿€¢ÖÒǼø˜ï-¬16©[c˜Ö5n›ªjÐô{•¤[(>‡Îž(ØÖÖîUE¿Œæ$à›àÆ>ŠÄ AÉtæ×žð»7*!oÄ‘„Fš ‚D…úq7;ÿ¬éiñ€¿ä‡cà ϲB ´Î¿œÜ,“hW.l þrrptµ nü\tOºMGoÄ»Ù|±;å¡Ï 4dú.4òê¡+;²Ë>­Ì9F8.Õ2 ÇS¬èØ7ä%ÀÂcf 3G­ZCLSHÁŸ.àh\ox:aøÀ ž½9èÕËÈøÝ¨6 Ù¥›“Ö ¥°_\8û+ˆ‹ZÆÌpŸH¼.÷CëYOý «Œ^ÁŠ~ã¦ÌØñ„/wÄ¿"(‚†É$}¯“0eV“QZó ϳ@ …»…2mü@Bn”‚eoÛµJ#[•‡²Î[OÜûv­ã¨êݦëG®Ô'×-ÀÌS8N—x'p<$uÔ´;Ûb“€Ž"—¥Ú'8ñéá»né™ûNG†È|2#\ ÍÛ¥|F¹i‚P©‰šÚkwÜzšNF1ºØá ™ÄbFà&²x/tž“%~¡ñÎ;H:ËN™ƒÄ°Vp4u?lNÌÔX}¼ºzûÏWWW’æSˆÖšB4JŸ¶Þ•_ pg2zŽÂØù,ôu>b;€šè$¦à´´Á‹yò­ †$OÁ!´·öØ´½ÝyVKá¨fpñÐ ÜlQä5OEÓ®¥ôj-)ÊôÙ´ 6žŒ:e8Ö3q˜ %NÀ}X¨c”“F|_† é  ÊŸâ$¤àf zeÀÀ#È >æéMM5˜\÷Ž›ö¶ Ž%öYýèBÎi;} q£œ+§–;’!—Ë !‹ÅhéTëÂUd‰f$· ‰Ò±·;š¹ô³v¶'Âçdâ¤ì§Ûò‹Ýý´„Ü„%§jÆQ»Àˈân:[Ž?…jìÖ•;à¸ï[8 /ζ´ü«sÂA§ÚËL±_ýùƇZ%„Ûj?ãì’X,›lÝcègLŸ"Øß—¬b„=w¶:3&Q·##<±a'ÔñÕ†*Ñj ø+ÈMs¬‹?ãùÙI¤ÆJ¡´; Et¶‹(‚m̘³±ß_9ÿÊ]RfÉ] 3Ó}g ¡ÉMùöÏ7ÿØ^-¡2õ“s‡i0ÝAØbë#µ\’ O`iø2€Áw¡BuþŠHXŠœÉô¦·\œ’(œƒž<ª?yN]Ò;ÅQ#\D¯ËÞ›¤Tcï¬_ή„òx Jû5?!¨&èîFN¯hDþ=t$)µð6¡ô‡5¼h¡ÈnwQ ò¯”nq‘Á]ÒW6;¼u™L@/DCå'oí§¡líãmÃ4¦a n€ [ùŒ:‰þ¨i?R·Û8xŽ€b=i{Ìí!Ö>öR€ˆ»ZUþÚ×§ÿ.hçfäJ$€2®$¬ha€ÕA“†!þö//¨žL:æxkî¡Ȭ´>C„»:ˆM¸QŽS—}“,ïI n{ä4¥¢7^F£ñ; f8pK¯ÞÛÓ¨¶è?þâÉÐu ˆ[»ÙY1ìø½ŸÄ!‚„àIîZÉÍ=ì¼¢ŒÉ'52™É $™â‡(âŒ%:^ - öþ¡C‰„ü[*Hó²ï9Å”ñtÎYãEàÊõÍ,äùë3/¹' endstream endobj 66 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (./C60.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 70 0 R /BBox [0 0 274 289] /Resources << /ProcSet [ /PDF /ImageC ] /ExtGState << /R7 71 0 R >>/XObject << /R8 72 0 R >>>> /Length 63 /Filter /FlateDecode >> stream xœ+T0Ð3T0A(œË¥d®^ÌU¨`dn–R0²°Qºz@`i`aQg¡à’ÏÈe $MN endstream endobj 72 0 obj << /Subtype /Image /ColorSpace /DeviceRGB /Width 274 /Height 289 /BitsPerComponent 8 /Filter /DCTDecode /Length 39372 >> stream ÿØÿîAdobedÿÛC       ÿÛC  ÿÀ!ÿÄ ÿĵ}!1AQa"q2‘¡#B±ÁRÑð$3br‚ %&'()*456789:CDEFGHIJSTUVWXYZcdefghijstuvwxyzƒ„…†‡ˆ‰Š’“”•–—˜™š¢£¤¥¦§¨©ª²³´µ¶·¸¹ºÂÃÄÅÆÇÈÉÊÒÓÔÕÖרÙÚáâãäåæçèéêñòóôõö÷øùúÿÄ ÿĵw!1AQaq"2B‘¡±Á #3RðbrÑ $4á%ñ&'()*56789:CDEFGHIJSTUVWXYZcdefghijstuvwxyz‚ƒ„…†‡ˆ‰Š’“”•–—˜™š¢£¤¥¦§¨©ª²³´µ¶·¸¹ºÂÃÄÅÆÇÈÉÊÒÓÔÕÖרÙÚâãäåæçèéêòóôõö÷øùúÿÚ ?ýü € ( € ( €§Ò€ ƒÐÑa]1hP@sñWâN‹ðŸÀÚßõ¿ž $Ä6¡¶µÜíÄq)ÁÁfÀÎN8­)Su$¢Ž,~28«.‡ã¿?h?üN¿šç_׿‡Ncû½*ÁÌ6ЮrÐ~r?¼å¾8¯ ¡B¡ùmšâ³ >wîôF&…ñ_ð¼Ëªè^*¿Óu+FY-Ö ¤‡vJ²çiʰ*܃ï­HB¢³<Ü'ƒš'fÔ¿ÙŸö€ã^…ªZj°Cmã Æ/#ƒ";ˆß;%@zd«¹8 Œx8¬?±–›®d9¿ö•+Oã[ŸOW!ô@Ö] È= š{ ( € ( € ( € ( € (  Oø‡G𞇪x_½KMN…§¸¸“¢(éÔ“ÐÉ$’j¡7ÊŒqᆦêÍèÌþØž9ñ]ôÐx.SáÏ©*›Ks8ÉÃ;Bd`í^ŸÞ5íáðâ¯=Yù†kŘªÒqÃ{¨óãçÆ*V›Mø}1¶¤hµIÒádPrF%Îãôç+yàèÉly~"Ì©I?h}¹ð—öÃðŒt{¤ñÅõ§‡)_ü-Ö£ñ/…/…¦¼Öím,î¢A,LT²²¶F7*ŸªŠR§Nª´Ðèbñxœô·ü9ûzx–2?á ðÖ‘­”’Z·n¥Œ€ñžÃ·ãË,º›ø]~âiiVŸ1ï:í·ð»Q&«¦ët­ÍåGºñŸŠ#ÔîÕ@ƒH·VŽæáÉhGg%סÅ`êórÉXôjq&غ”¥wØøÅ?µoÅ?ßÍ=¿ˆ_BÒ÷î†ÃH>_–;—ï¹ãœ3œ8¯ZŽ ”ªìüÿ1âl}y¿g.Xö5|%ûIüYð¸QoÿkéH‰6›«ºÊó/³‘æƒpzƒÅUL­Œp\Q˜a¦œåÍÇé_Â?‹^ø½áˆõíÌWŠÿOüösm©õSü-ÐBz2£+3õ,«4§™Ñöߪ=R±=@ € ( € ( € ( € ( €?>à¡4»Ñ<àÏ ZÌÑE¯j/5ÁIvù‘ÛªŒ¿Ä»å½{â»°1¼ù»)ÅUœh*Kí•–úÐ`yB¡ ë´zײ§cóYaîmß[ßÜIr4‰ÒîÉIÎsz…<Æ«W±Ÿîé»3Êo¼K}¤ÝµÂnŠþÕ³²@2ÐûW<¦ÓÔõhÐHé³(jßu[ÔïR¹™GD’RBýARë›Ã+Mìsž.×|Cxšv‰ew¨I–¶P¼ò?ÑT*Í×ó;iå:Ù#²Ô¾üx±ð~£ã½cá¶¿¥øVÌBd¾Ö û™æ¶Øü¤˜«Ë“ÿ<Õ°'ƒY*üÎÈí–VèCÚMYG¢ë“™çrÛ%[‚µq‘ÏV‚û&•þ¢Íç¨Áèj›3…-u;ÿ†þ ø±ñ2ÓVºð'ƒïuæF$º·±hÚuCœ2Å»{‚T‘[œË.aÖäÜÚÖTÕìG«Ëâÿ]%Œ¡qçK9dˆmAžrÏ¥5S™ŠXeJ6=WA²Ö&ŽÞ{•Y¹vå•}v÷úVñR±äÕ•.nQ³øŠ縷Šmë•ÜFÒpzãµ.pX[ê¯aŸ5—ÆÇðØšSi¯é“ÄbNWÍ‹+·#T”ƒ÷ñß#ƒ”¡~Ç×p¤¥Cìú3öV¼sô€ € ( € ( € ( €h ØLƒÐÐ+¦6I#‰I]Qe™ŽšMì)N0W“±ñgÆÛ7Á~ŽûEð7•â&Sí scnÜçs©Ì„|©Áçæb»¨à¥?zZ#å³>&£‡½:ôÈOügñ?Y_xÇ\šòX½¨%`³FÀ+ }|©“Ôí‰<×z§JÑ>Fxºù„ù«;ž's¯¯’y%Hç”9„púžËà¿Çs¯½H+ÏÕJw<êùË{mR3]T°þÇÞ“<Òý‘ÿisû?øæóY»ÑßTÐõKAeyh“´,ªYdOá,¸8Ü:®I¢pöª× .)à*9¨Ý3÷kÂ?´Àÿ‹> Ôõ‘®éÿØÐÛùÚ–™¯¢FðG‘þ²'ÈuÜTew.âsÅrKRÇÐÒͰxŠnRi[t~x|iñìõñõ;Âß¼2±Ë!?ð‘=±Ó®'<‚ámLoÜ]Ή;W§‡ÁKy³âsn% äáBŸÌùNÏáW†¬5 52Úá-ÕŒ¢ÇÌia„{Ëà´Æ»¡‡ŒYòµ³j•Õž†¾³ªGelÀü Å\¥drФêÌùƒSñ wš¥ýÄ2/~ÒÊ~ñϵpJww>ª–Æ 3gÀ^;Ô´?Úk.§qc¨Ø|ÑÞZÊcxØñÑÆi'»3Jž)Óv‘úýð_öìŽxmôŠöí3`*ëº|K¸œõšÀ韚1Ø ‡“\õ°)ëLö2î)•;SÆ/™ú1 x‹CñN™m¬øwVµÔt¹Æc¹´•dFõÇB:ƒÖ¼ÙÂPv’>Ö†&–& t¥tläT›hƒ ô4iì ( € ( € (Ä^!Ò<)¡ê¾$×ïRÓFÓ k‹‹‡‚"Œž$žÀI$ 5P‹›åF8ŠðÃSuj=ùiñ#ö»ñÇŒ/®mü!{'‡¼4®DBßêuÏ $œí?ì¦1œÝkÜÃàiÅ^z³òìÛŠ±Uæã‡|±<¯Jý£~1øbyuM?Ç·wilÂIm5›sÀ°R»d%±Ó„ ’1Ö´©…¤ÖÇ?Ì)Í>{œ¿ÅÿÚ‹â'ÅkhtínúÞÃD@}3JWŠØwÈ™œä p1ÀÎIΖVçf;8ÅæK–NÑì|›«x™"WÃŒú“W*–9(á\ž§yðörøÉûB_Â<1áùl<+ /‰µxÞ ›¶·”Øýó›åLò9+Ö¹*âO¤Àe+4ÒÐúóÇðKO[hÚIøkñ:ÎóZXÂßÁâ8^Ú»Bñ,Œ£¶ÆVõßÚ¹V'¹îTÈì—+Ôøçþ¯‰þ x£]ðG%µoXN$ô ŽÕéá¥ÍcᳺNgIîDÒ®e»’+{di'íHÐd“í]ÊGÌN“¹j}nòÆ+ëD™âY—Ëž#Æì„}hlP¤yV°F£wmf.L"gÚdSÓðïXKÞv=Z Ó̽Oàå¶µÇÿ mÄ>rcLæ¦X~n¦”ó‡A߯³žŒâÛ£ #æ6éŒwã?JŸ©®æÿë$ÿçÙjÙëDŒ†“Ä÷ÇhsùÓú¢îL¸Š£Ú_ðÏúdN%O܉;Ÿ³®:ö¸ãëÏ>Ô}Q.£ÿX'- –Úx>òßN]fkøŠy€H¡B‘ÀÑÉÈìD±/$¬zŽ•¨ òpë¢2<š´µ:¹5MCG’æßÌšÖwŒÇ,d•,Œ9 =Å_1Ψ³Ì<]ÿ]'Q²ŠaòFÂ9OD|p~™ëíšÂ®±g§%X¶} ðÇþ qñ/RÔ,Ÿâ´}#ÂêÙš=g¼¼1Ÿ‘ž1d‘óØþíx“Ä[cõ >PçiMžcñ¿öøÇðN{ÝoÀ–÷;ðmÿjÓaΣj (kEË?/ðïBÌ#URÄ'¹†;(’Ö£å ŲÀÁL‡ƒ‚¤ôÇjî…Såñ8èú§áíã/†×¦ûšãZ‰¶ùö’$78Î7¡àã'‘‚3Á¤á ÊÒG&ŠË'ÍFG¼x«öÁø½ãKõŽE¢iáIKm  HÅœ¶=à ŠX:QÝ\ÛÄxêÿ åF÷„?i_‹~¶QxÓûN_O×steÈë¼âBÑÒA×ÜÖÓÁQšÛS‹ ÄÙ†kšw]Ô„4?‹¾·ñ.Žo:9‚òÂV ö“ªHê!•»‚2È"‹¡+3õ«3§™ÐU#¿Tzbz@P@PÃ?·÷ˆõ àæ§ZHÑÚkå½µÑ4ŽY‚ûimÿ®Ì¼î|×ÎK É™ùe¬B$·K©™-Ù€’DŠ®y wâ½¾k˜:g?â}fbÎåÚO”î6±²ãÜf¦SÐéÃÐ×cÈfñ4×ú…¦š’ˆ§¹•!V—!U‰'œ 猟jåsoD{4ð‘Šæ{±Ÿ²ÿì5ð©ô}?â'Äi¾?»¹WXÙt»oá;ƒóH0GÎT’6¡«‚µi§Ê}nY—áœVî}ÿ®|LøYðúÝ4ÝcÅš–PªÇ¦¬ñ«ÅP'Í´À ½°+Ñ©Sdzu³,{óHñ~Ù? ´ç–ÏY׊©+qekå@Håå*@½óÍtGSíhxØŽ+ÂBê—¼~(xûÆz¯ˆ¾"x·_ñ ôw:¶§z÷rIî@•XþfÂ*án;Bž+Ò¦½šåGÆbªK'Z[²µŸ‰%³–+›K–ŠxÎä’6ÁSìk^sÏx{”¯!Õt¥”AxŸÞO1U¸9R1ÊpYpÇÑŒšÜøºÔ);GtŽ£Ãš”ÌñKrìªq’9*?­tBLñ±b´G¦M®ÙÅ<ñØÜ¼–ªÄG$‹±˜v$sŠßœóe†mŸn~Àž.ºo‹>%ðôwýƒPÑyaQ•iaš ŒÞ˜Yeÿ·ï^~>ÒŠgØp“•Ò‡F~½W~†P@P@|/û~ÿÂ3¨|´Ð5;é£ñ,Ú”7º=½º†2IRVDNàŸï2õÛ‚„¥;­šâ\M8~Y¿yìÃ}RòçFc’‰dÆÒ>¢½)7áèÂ5µ±Ê]kh ņ¡¬Ü®vB‡)Æ5ôpj–“§Ê}ÙnDZüðk+ës¹AÊ›G³xwãˆü/¦Þikš‘ðÝÉg¹Òá»’8eb–d€õéZ©E;´qN…IGÙÅØuïÆxAd¸Ž.>SGp÷ÜA#ó«öé±ÊªK}L«oøËƲÝ?‡tms\¸‚)'—ì“]4Q ݶƒ…PÀ’xÉëPëÝØëŽWìâå%¡ë~ð]Äp¼Õ¥µP.vÿ±ŸAÏë]p§ev|æ#œù!²<¿Å²ÛèòÉ=¿îÂ<@ñøV+Ðõpqu•™Æ?ˆeÏ™òõ¬œô;ÖÌýýˆÿcÛ¿ˆ:Ì~.økþ-ýª8Ó4=^Üí™Yp&hØs†%OG|œñ×­Ò'ÒåYeÿyUh~¢ÿÃ+þÎ~cKÿ c˜¹!tèÂÄ…ÆÈp25ËígÜ÷_‡dxý–¿gPÛ¿áMxW>cIÎRrxÇNx^ƒ QígÜ_ÙØoå+Kû'þÍóÝKy'Á¯ y²¥RÉUÌ[„Prz€8éÅÖ}ÇýŸ†¿ÂX²ÇìâGÿ SÂBºó¥BI qœüDZÁ `ö²îWÔpëìŸ&þÖŸ±‡5ßG⟀þ Ó4h~lòèš=¤p jm̃n?zœ˜Ç#@WQ®âýãÍ̲¨Ö§zKT~.ɬÝi×Wzn©k5ž¥i#Aqkt†9!‘IVGSʰ ‚ ŒW¡‰£ã*àå Y£WÃóî_žcöXÛ ˆp\úgµkÌÎLL]]-O¦áð¾‰âß MáW¶T—k5“B£!&1îH ¿ídcæ$u:jQ±óðÅÔ£[³ä-_À_<;k¨jïámjO ÚLÐ>»ŒÍg¸pf`lJ“‘žkÍéÊÌûl*Ž2’©¡…¥ø÷\Ò”¥ñUêQ°F~†œk4M\¾Ýü¾ Ûi†ƒ¦xŠÿNÒ¯”¥åµ…Ì‘GtŒ»YdPÛYJ’#qÓŠn¢—B)á%FéIÙž_¨ø„ë•­ÅÓnš4ïÀS€rzŸÎ¡Ï™êoOìâÒ;7V#PZ¶R<ú´[fí¥äÚ­ÚZZȉù¤~‹ÿ×ö«O™Ùó‚¥i¨¿°á/ x÷Ä_Ú7òÏâ}gLH4Û©‚¤{ÃÜB>lïb!`0~X‰Èèy±Ô¤¢šØö¸_FU¥NZIì~¹W’~€ ( € ( _Æ~.Ñü ágÅšôþV™§Ber1¹ÏEEÏVf* w,+JtÝI(£“‹§‚£*Õˆü0øÏñWUø‰âWÆ:àXgœ­ìÑË¥œ ‘)=q’IÀË3 à} *K #ñìv6¦m‰ue±óÿÃÏ…ž%ý£>(X|;ð´«jn#{‹ýZXšX´ûtt®2I*ª22ÌGZâÄVQ>“(ËåWD|ïãÏk_¼Qâ/j¢Hõê[)ãœVDb­Ó‚8È àŒÁ¬ù´ÐíöV›Œ–Ç—]]]\L¦g_”çb¡¶Î¨Â)h}]û!ü—öø¹¦xS]F?[ÛË{­ßiΑ½­º®kº° ò˜Ð ¤à“ŒDΧ*6Âáj©[C÷ÃÀ¿°÷ì¿à ’éß ´ÝNõ[Ú¼F[SlŒã 1dÏeP r:’g¿OFž©/ûXüW²Ó£à¯¢‚ÏO‚$m]¬ÉH×˵P¸Ù‚ÃÁ@:0–äý¤‰âÌæ4×ÔèoÔüçñ«”ŠÀ+Õœ”QðXjN¤®Ï?ÿ… ñâ—‰ß3¼ð|3âè¬í¯%Ñïa¼[;Ø÷Ã>Æ REã(ÀGpk=Z±×rJK¡ýmøÆþø‘à¿ xëÂ׉s ëv‘ÝÛº²±PÃæFÁ8tmÈËÕYXEyòM;3ëèTX)DìjM‚€ ( šÚKSù´ý³>0h_>5ëºÎ… ³øcGA¤é÷¢«j ;çg\ïVrÛ ?êÕ8‘^•rÇSâsò'K‡÷ŠØ%O\ƶg›­©¹cwqŒI&1œò*Ó0œØúËÆ¼yð_À¿ þ$k¥eðï­ºýë ‡Ý,PÉŽ2öû$^s‘"6rR¬¹¹IÇeÓTcQ­Î³áÿŒ§µšÎ{{¹-î ‘&†x[ªr’!ìÊEz1jqågÇÕL%UV›³GîoÀOŒ–<.ò\‡Åz_—§lƒÌÃå–>Oîß Žà‚:O‡ŠÃºò?RÈsxf”5~úÝï\§¼P@É$H‘å‘ÂÆ£,Ìp$Û²&rPNRÙŽÿ´ïÇxþ'ëég¡]·ü ÚI?c%#y!tέƒŒŒ( 2x,@÷°xcinÏÊ8‹8y•cEû‘üOÏßêz†±¨Ùèº5¬÷ºµýÄv––VÊ^K™ä`‰(ä³1ÔšªÕRW9òܪIE#öOÀþÑ¿a¿Ù¯ÄúýÔöÚÄ{èÅÅíï—òÝj –öè7h!,3óÁe-´y)¼EK¡ÍC(Á9u?þ-ÞO¯j7þ$Õ._ÝIqqvÀ¸–F.ìÀc©$ñÞ»ªEE++‚­:³n]O¶gø&–¹ñƒÀ>ø•ãOˆÃ^´êßH·ÒþÓsqfXíÈÒªÄd@Ù>WRGjá^Wd}N.u`¥'cö_à_ìûðÛöyð˜ð¯Ãí2Eó[̼Õo™e¼Ô$þôÒQÀà*€ t$œ%7-Ïb†¢g~пlþx>Wµ•_Æ¢¼]°¶¾0Ó8þâdsÜ‘¾ƒ­?#Éϳhå˜vÓ÷ÞÇãN«©Ê ÝõåËMpí4ÓÊÙi]Žæf=É$“õ¯¢IS‘øÜ¥¯%Ë%‰¨’Gô%àÏxkÀž оè:|iá½.Å,#‚TCç ]¬Òàîü³¶>ff'©¯RmÜýB•Ò¦ –‡ó ûb|+Ñþ ü}ñïƒ<7{Ú L—¶°EŒØ¤è³ w¥7áqŸ“aêH°nQ¹ó8šq§YÁ~~Óÿ>ØøSâ[3Ï”À\[«I'VQ¸ç¶7O­iB8ê×ÄaŸ5XýÈýšl¿ü`ð½ññæ± xkÆzl¡'·šõ-¡¼e–+g€¬w6ÜNËWâýÝs›Â´-]ÚHúI~2|$uŸ¼(Èrw fÔŽ9?ÇÛò¬ýŒû¿ÚX_ç@ßþ¡Pÿ¼*¥ŽíbÔgéóÑì'Ø?´°¿ÎŽ'âí/ðÀ~Ö[ cKº’ÒöÂtÛ$Få7ˆe ý+¦2¹ãW¥ìï§ï×ìgãþÒ?³ßˆ¾üE_·I¤Ú‹¬I’M=Àò$WbØ–) @C€pkñtä¦K,­]‡©º?1>$ü9ñOìûñ3UøsâyZi­6Íe©,F(õ;WÎÉp ‘“µ•—'݇­Ì•Ͳ×Bn-h{ÿÁ‹šŸ€üO¤x£JÉ-±òæµ/µomÉd,}ÀÊœ0SƒŠë«N8ˆr³ÁÀâêe8•Vu?rüâýÇ~ÒüSáë±>™}‘NFèÏtp ÚêrìA¯Ÿ©MÓ—+?^Ábéãi*´ÝÓ:ŠÌë (¬Ë³»E$œ(K¢¤¢®Ï‹þ&~ؾðÝõö‡à](kº…³´RjËåÚ+îËKƒq´qÃô¨eò¨¹¤ì|^kÆp“tèG™Ÿ(|Ný¬þ!øçÂZ·„¤°Ó4ÛKò©<öjÉ$8ùâ%˜ðÇ#ør§95Ù )K˜ùÌ_b1ô]Y3à?x´[Äñc#±â¶©RÇ™‚ÁûI\ý-ý€¿fItË[Úâ.œÃ_Ô#'Ã:uÊ)û£ ?l<’$•Xª ±äóæ|¾6"·;²?JɲØááí&µ<ÏööøÑÿ gŒâøo£_¬žðÃî»ò]Y&Ô!²Gx•ŒxÏ ddWV—,y™áq9×­ì!²>øðkPý£¾7øwÀ°ÆÿðŽYÈ·zÕÊ3/‘bŽžv)Úì21½†xÍN"¥‹Ê0Ž£Hþƒ¾'übðÀIÓÕíaK};ÃÚa8QJ©Û#…v…Π´0òÄ=6>ƒ4Î(e4ýí_câ oöÂø¹ªNÒé#IÒ-3”† o=€ôfO¸UéÒ½Xe´Ò÷µ>ƸÉË÷^ê>cø•ãŸøûÄ/âÏß ½DÁº¢®ÈãDÂ/EÉË8,Äñšê§B4¢x¸ÌÊ®gSž³ÔùëÄ^ ¸žtÓí¡–[é¤ÅjYäv8UUêI$;泫S•X«%Ê~á~Èß³½§ÀÏÇy¬Ú†ø•âã¹Ö®ƒ›~ KT#€±î9#;œ±É@ð«Õu%ä~«•à#‚¢“Z³ë3Þ°=G±üÊ~Ôº+ÍûAüc‡Ä–í%÷öýÛ«J¬ä;—‡ž¤yM;‚8ÅzÔTe|c:”±R³>\Öt»])áŸL·YãlФ¶דß?§½9EGbhÖuU§¸ÿøª}X·›cKc"•š5l `Bõ¥œ¬upžÚ۞¿-Q‹ˆ±2ÌH'ò­ÕTy/.¨ûŒ—âD ­åÄC„Ìp?J=²–ÏÌæ5¯.­½ª Œe‰ ϵC«ÌtSÀÊ–®å«KøfkhîÆÉ¶\à¤nÇ#9âª÷!ÅÅèdÚ%••ÙºTUu_lúTÙ-Mo9ÙÕ7ÂûmRÇá¯Ãë=qå}j Æ;Ç™™§ rŹ'p9'œõ¯"±ú.5F)öñ3áφþ,x#_ðŠíŒšN©Gæ _2ÖL|“DH H†RA‚2 „ÜÐñ4#‰¦á.§óÑâÿx»àÇŽ5‡þ5¶h5]>LÃ8ÿUnIòî!?ÄŽGu!‘°ÊÊ=Ì=e4Ë3l¶Xj®-ž…â-P­”öIiwkÔ#½Ò/cÁqFå> à©  ‚¯*p”¤}îKMU¤î™·Rn|‡ûiøúûÁŸ[MÓ&òîüKxº\ŒÌ-Š;ÍŽß2 Œç´‡£³MJ¥ÙóœKŠ–ãfÏÈÛKç•¡·€šFˆ:’x½õ+#ò9Rs•ÙªxšïK“Q°ó<™¤V·¸Œàñ‘sîOJ‰H飇<ÞßRðÌ)ð¶¥âÍ,j^±Õ-nµ ¡þÕl’«K2¹Ü—ÏZã­ïGCè2ÇìjÅËc÷«ãíQð«áφ|C•ã='Rñ¼6²¥Ž‘§Ê.‰¹"¬…2©µˆ,ƒ…8æSÃÎrÕh}Þ37ÃТù%ïXþ~¼_®ÜÜI}¨ê7“\ßNÏ<÷Èd’i–ff<³I$œ’s^¬šŠ±ðTa*Õ9ŸSösöø1mðkà•ïÄÿB°xŸÆP.³s31­tÕBöéòç’ŒÓ0þñU†SÉ«.yÙ eôêK{øÇâ.«ñ/ƺïuŸ’ëR›z[ï,¶Ñ#‰IìªÏ9=ëÝÃÓTâ¢~U›â§ÄJ¤‚ex^HÑ™ÌBzé¹á8]™Ú¦¹u%„zl“æÎ'2$d•\Rfô¡fu?³-Ç‚àý£¾]x»DƒPY.Z 7­¥ëöy¶tfY0‘ò3ey¸Åx6³á©¨b¢§³?|Ex‡ê7W6öV×—s$6°#I,Ò°UTd’O Í4®ìLä¡&4?µĤøÉñoÅ_´¸âµÓåeµ±CˆÏmÙË“#œ¶H/EP=Ztù Ïq˜µ‹ÄJVЗáwìû@|fðö‘â øJÕ|«<‰¯©ê0CF˜Ç¸Ë´20ÈŒçf³xÇFvᲺÕRœ‡ígì­û(xSömðmÞœòÁ­xÓW*ú¶²ÐmYB–1Ã1;c@ÇÝ›,qòªñT¨æÏ©Áà㆞¬ú}ô- üýú5‹yê«.ët>`qÈÍgÌοgÃO‡ô‚ fÑ, ¼*©FÙ Æ«÷BŒ`Ø”s0öpìpŸ>øâÏ‚|WàhÖâË^‹l·–ð¢Ï à~êáë#l2“‘Æ \fâîgW ±qksðóâ'üŸö”ðf¡z|k¦øßAGcÅìV7-H'eUc“ò¤ÓéžÈâWSçkd³OÝÔøCAñ$ºN±¦k¼?nÓŽÎT26 ŠÀ©PG*rCÁ"·O™jyN”¨ËÝ[ÕgÁ/Šº/Ɔ¾ñö$`ß@«ymÏÙ.•G›ÿuªAï^mHrJÇÙàñ IM±PuŸ’?ðR ßKâÿ†dz5»xò9®n5@¬²­r±BÄ|²!”NÀ”*ØÛæ6ïC›»>;Šg£µ>(Ñoj ó^ÌYù­xjwö÷×¢ ¸šH˜Ñ̹_˜wÚ¶¹Á(úž§4Ó=Ì“1¸fÞdÎìç9õÍDýíчæ§%%Ðýað…®“ûX~ËíáïN“j…¬š}Ýâ¨2Zß@ߺ¹cdE.8v1´â¾v´}WcöL¶¯öž^MÏç+ÅžÕ<â­cDÕíŶ±¥Þϧß[«‡\Âì’(aFå<Žn+­;ûÈùÚ”ÜdéËt~ÕþÃßµ¯ƒÛáœ>øâ« 'RðóGo¦ÝßËå­å£gjnåý…¾!^Câÿü<šF}/P´:” rD3ÆÈ€ÑÆIÿžJ:ž|¼ÂšiMuÁعBrÃËg±ú‡^Aú!ñoíÕàí_Ä¿“YÑà–vðÞ š•Ô.òm¼¹#‘ð9ÂoO@ªÄð2:ðu'©ó¼I…–# ͇âÂêk-Õ¤!ðÀ8=«ÙR¹ù«¢ãÎëWÒí.ôÖ&%—–Ç?ŸZÖQMk8Ô>UÔ®.ã×n4W _ÍU¹el`ÿO¸%u+YJ1tUDw>"ñŸhÍæ’é{FySîkII#ކsw{Ç…üB·4ð•åÿ†%ñ‰g©Û\ê:>2o­£•ZHsÐoPË“ÀÏýb?¥‘ÐWŒÏÒÖÇç§íùñ­¼!àËo…Z ÞÍÅÔ6ÃA§TûjÀ§û© î+³ Kš\Ìù¾ Ì=?a«?%>|,Õ>8üPðÏÃ%¥ŽÞîC-õÜi¸YÚF7I#vaFz³¨ç Wezœ‘>w,ÂËUDþ˜4 I𾇣øoA²ŽÏEÒí¢³´µ‹îà j}^Cm»³ôJpT⢶F½"€ (ö ç—þ Aû8§Ã‰¶ß<+aäx+ÆŽZuˆ–¨¹2 UP$@$PI%„ÝŠì£>en§ÎfXg>u³:Oø&÷ÇÔð'î>ø‡Pdðß‹Z8í̲b;}DqÁày€ùg’#…UhsÆèçË1?W­É-¤~ûW õw??à£V—º_Ç¿ j×,ÇOÔ|9[³¾B´SϽêÞ­é—>õé`ä­c⸒Œ¥5#ä/RˆÆ„=zqgÃU¥©ÙÍâ«ë‹+ îÙìíy1“Ân98úÕóÞÆìĹÕÁç¤åbáDúËö\ý©%øG¥]økRðìz‡…®õ¼–{W)u2¢3.ã±øp¿/Cós\Uð¾ßÞOSéò¼ùåV£8Þ'Ͷf»áŠŸµx3F¸Óô+û H翞"Ÿn»Tù¥ÛÑYWdDgŸ+<†ÉÎ Ó¤uã3\>.¯´¢|Å¥\Çáù«Æ ÆÀ¸v$Iß±鎽«Hû§ Dë®dR×µq.·u|‹µ.6È‘ä£v‚NN0<ôúÒ“ÔÒ•?Ýò¾‡Ð~Ñ¡[g¹‰âU å”zþB»iE[Sæó ÏžÈ_Κn¦žAÚ²©,¾¤wýiÏÝz Z7‘÷OüÛÂú†½ñÄÞ9•ižmùK™ÙHô!cGÈì] y˜êžê‰öœ/‚j«­Øý¯,ûÒ½Õ­µõµÅ•í¼sÙÜFÑKÈ$Fee<A ƒBvØ™EM4Ïçoö‹øk¥|;ý 'Ô,Ýâ–{GK{mêJ•Y%°A‚m8È$WŸ ä®ô>ÃÄxzSp§ïŸ~*k?ü]âxšé_RÔe%bC„µ‰F#‰誸§’rI'¾T£d|zµ1µÝIõ?bÿ`¯«ðÓád^:׬D~7ñ¢%ìžböv8ͼ<ž ÊÜ™v ó1yåcîrŒÃRR{³îêç=€ € ( #øåð{Ã~ø‡á׉‘RèüËKï(I&ŸtœÅ ÚÁ®d¾ñÒ-´{BŽ™#{±á Œœ’AÀ88顆•mVÇ‹šçt2ÈÚZÉô?¹¬ÜìvÓÃ93ÍußÛÛîS6[² Âu‘êPˤõh÷ØêÇà¿Å_‹ÖÞøÐ—ïð ¤Z­èµ´¹¸Ÿ*àŒ9ÝŒ Wl) ¸c’µI8Þ'Ñe¸J¨£YÑ_‡|/á h–¾ðƇ§éšªyqéö$Q Ç#bŒsÜõ=ëÎnMÝŸcÒŠå¬|ùãoØ¿ökñåôºž¯ðÎÒÒþEÚÒhwé¨Ý~c‘–Ëd±]Ç$ÕªÓ[3–®Y…ªï(ê~XüføU/ÀŠ—ƒá–i¼7:‹Ýêr IjäŒA9xØ4dœpía+sÅ_só>!Ë–»Pø^Å; ×lfЮ'Hàºù¢yHÛÀaI=ƒ}Òzr û¢»šRGÊÂn”ô>}ÕlZËQº²Ôg[pŠÅZP߀y$cêyÅrIrè{Ô´I£É†ð®‰“§B¯Ì›Aw#vS‡*>g]ÖÝCNÕ„ÖѨyÕpM=Q×Yëi{4%I,¹?JÕNçJ £Õm/u5#cçÛˆ²)æÆÜ~*kxÈó'OS˜ñŠþÊx$än\öaÈ?Dí$ta[¥5$~±þοµ§†þ ÙøkÁþ,Yt¿µ´6Éwu(’-Ru@‡ÀÙ#HVà“€Ä‡ˆÁÊüuGêYGRĵB¯»/Ìûb¸O©¹üò|Wø…}ñÇ>0ñuÌò°Ô.ä6Â^u;bL@ÛQÇ|žõôt ©Ã•æ‰cq.¬ºž]¥³Ú,i9qæ) T“×ߊ¸³–¼/ª:DÖ®,÷=µÃÆåJ’‚Aê>†­ÈæT®Ï>ñ¡ö»i¡$àžkɳÐÃRå’gšøCÕ|iã¯ø.Êîc>»ªÚ鱪Îf•cžÞêHõÇRm#èðt#Ri%©ûýûR~Ǿø×ð¾ @Óôß ø³Ã6¬t B– E´Á@Cã¯ToœgæWó¡Q©j}¦#Nt½Õfæ‚#6“xgI6Í AÆpk±+3+OCºðÆŸˆ¾Ö­5ï øÇTÒu;iCÇuc1ŒžÇrŽH!A¦åÏ£RxwÏ©úÿøÕã-û6ûÄ–šÜ¦›DµXd»qæbJ3rO—· Ѐ.• KVŽ\~k—» Y6x³âœÚö£¡ª_Üßê^fé/¯.y˜c.çž¿¥tóÆ#Ãú­jוMYêžÕ’æö¾U€Á»)ÊçÏb¨8Iè^ø›áöñ&‚|Ef3ªFv\ôÿ[Œ«Ÿg‚¼ î)UÖ†¸ G³šRØøªúòúù終#çÆJÉ»€„pAÿµæ»½±£BÒoCú‡ý™¼Kàü ømyðñµÒà±[É%Œ± I!žK«–?{!‡ òªÅ©j}î¤*Q‹§±îõXP@PkË»[ K›ë똭ì­ãifžw‘"‚Y™ $ð¦·&ME6Ïå§âç‰<9­|Wø‡âYI‚µMbêîÃtfc1®©®D{£u±]ØÀ®–ùQãRƒ©#ç _âMÆâˆï4×&êɃG,ryo C+U€î=k‚¥UÌ}V/—³RZKü4ýºþ+øNÓì–Þ'–úÚÙÝ7[Qx¼à ²IÀ0=+R¥SVµ=:XìÃhÆw‰ãÿ¿þ)^Ýë>-ñ=İʤ.™i#Ciq! ŒtäåŽI­iÒ…5¢81˜üN2¥êKCäNúþúöI®Ü½á?>ïáÇ@=€éY½ÎÊi(­OØoø'ìÕ£K£Øü|ñbÁ}¨LóÁ¢iò*ȶa[a¹oIIYA)ÝÔ‚8ñZ÷Qô™6 ·zŸþÞ¿ cøcûJëRhZtzW…¼IekªYYØÛGomØ ”F©ÆL°¼À9—$r®„ÛG>m‡:ŽËFx·‡.8ÐîÉ=MzgÇb£vzzë÷2¤"âåä ±;°ƒž•º‘åÊÙF÷Wʧ,x=M'"éѳ,ø~þ{(mŒWN“ÂC$ˆÅY‚éƒÒ…ª°æÜj)Çt~£øsöÞ†ßÃÚ¾±á»‹Í^+8êìO°\LC¾ÑæÉÀõ¯=àãsë#ĵ£¬~~ОÔ~|OñW†/l>ˤÏq-î’Àå%±’F1m=ʱ½±;ѬªFýO34Ëg„Ä8¥§C拽]­f2B~£¦jœ¬a ëSJÓTÔuX“ì6SJÎÛ–3“œc?SMIÉ]ÊŒiÊÍœž­©ÞE ¶–ÖQ;°SXœùšÎråZ¸j £J'ììOûêŸ µ%ø¹ñ‡O†/ˆ ½4}9Öa¤FÊQæ™”iÜ ªÌ¨‡$—lGæV­Ï¢>ã,Ë~®•J›Ÿ£/Òn5ÿ ø›C´‘cºÔtû‹XÝÉZHÙ$rOnk»3ׯ*m#ùPÖ<5b«w¦j:xŠîÐÊ’&É"pH`A z÷¯c–2‰ù·µ©J«¹â÷Z{éÓÉk8!ùX ˆ¬lzЩí#t}õû~È–ÿ´ÇŠ|CâmSÒ|¡M³ †íJWÜïJÙTØ¡ ùX5xÍeR«§±è`ð+ï=‘ûcðãöKýŸ~ ü7ðßMŸX¶TÛ«ë u £"ã÷åÜ#rFvÐÅrʬ¥»=ÊX —»ó×öÇø?'ȱxëD·qàÿÊò?—XìµYãùT*‰÷‹’YŠËýÜש‚¯Ì¹YðœO•{)ûh-áz±nÒéL¶71."–CÜgº{¨¯U4ÑðR‹§#æß‰>ׯ.K)´™²ÌŸuŽ>VSÜ0Á_zâ«Wsé0m n ?àŸ?´Â|+ø£}àêBßÀ~2eQ$Î->ùp#”– *2å÷ù ûµçVƒž§Úåx•†’…ôgô=Ö¸ªNá@€ ( ̯ø(oí|1ᘾøZõ“Ä^"ˆK¬Í mtòHò²ÃLFäyaÁpk¯ K™ó3ç³¼z¥e«?,ì¯{m¥Æ„œÈò÷üú~>Õé(ÝØøŠ••8¹ßSéý& m2Æ8âUDE(wGD|µyJ¬îͯxSøÍñ'ßô¹d†;ù —·±)o±Ú Ý,½*ç‚î€õ®\UogžîG–¼exÅì~Óx—övø%ã/è~ñOÃmRÒ´{d´±7~þÖ$" “‚%$qƒós±sœ ð}¤¯sõ•ƒ£È¡Ë¢?/ÿj¯ø'§¾|;ñoÅ¿„z·ˆÖ„ÿÚøvþXîà[MàH!}«"ˆ‘™Éw‘ŠÆA9æ·¥]óYž^;,„i¹@ü¹±ñ©·ÚníC ç1çþzþuÞªŸ)SwtniiõÄ·Òù s+—h„bFím8=×ikÍÅI9»o‘R•<"æFïícû3i?´Ÿ€WJ‚{]7ÇšK›Z¸BV'8ß ¥Ao&@q’ «a¶í9S¨àÎÜf8¨[©üöx§Â^9øQãSáïŽ4seâ7ažÖ9㸠®¡ÑƒÆÌ¸d*Üá†@¯N•Nut|>;ì$ÔÍ)'Õì‚}®ÂhóË“ƒ•e §#؃ë]hñÜ Ý“*C«‹™Ë|£ þ¦Žk”èò£­ðô¶½ªéÚƒg5ö¯2Ámil¥ÞYà&›Ÿ*»"žUæ£~ßx[ö>ðE§†<9i¯‹‰5Øl-ã½’ÞâAÎ#Q!N~é`Øö¯=ãϰ Å¥vz_í'ð¿Á>xÄx£CµºÔ´­&öëLÔ$&ÓçXY•ã‘pÊ7"\ím 0#Šå£7+æg‡§Z„œÖ¨þt|Aá»k].Qå2Œä“…§NõìJ:œP®ÜÚ:¿„‘²iºh‘Ø¿Û .ßõÓ·åZQøN,Æ_¾Ðå¼Eo ¾-Òà™ŠE&¥;nÙ´@'w8úö®zû¶Rï8ŸÕPè>•â³ôøì… gäßü;öðm–>6èR\éÞ,Ô5{BÞ-­m{º9?zPସ*pÀr¹%ë· RR|Œù|ó Jœtµ?)ü ðÚÓâ7ƆŸ 5­NæÞÇÄ:½¤÷v†šäPìP:dn Ø8ÁÚ»åG›•ÁWš‰ý=ü1ø]àƒÞÓ| ðÿC‡LÐ,Æí‰Ì—K3õ’FÀËx€l¤äîϵ¥J4£Ëz #SÍ>/|6Ò>,ü>ñ‚uh¢?m„›[™M¥ÊŒÅ*ž «c§PH9ƒ¥)ºrMxì,qteJGà7ö7ˆ4 {\𶲂ßRÒ/&°º¶àeÊ6ÃÝr§¸¯¡£'4š?Ìh,5Wº:è4«yZeó nî8ôæº9S隦–ºþZ4†8ï@dq·*{ûÔNŒZ±Ù†Ì+R’jGê?ìÝûSx?Tðvá?‰ž.´Òüe¤G±¿×.Ö%Õжđd‘¾iq´8'$凅ðñ8YBWŽÇêyyOEF«´‘ö厡c©ÚA§^Áue2îŽâÞE‘$ªÀGÒ¸škF},jFjé–²=E"¹—pÈõX9—pÊŒœŠ,.eÜù÷âoí+ð«áæ…â;ˆüc¡ê¾+Óá>O‡lõ^æârv¢RYWq›iÚ¹88ÁÞ NIXó1¹­ %)Oší‹Z“ÜøßÅšç|W ¿ñN±pn.n¥ p¢¨ªTvUµ{ôhF #òLË3­Š¨æÞçAiá¤Õ.-ìmmK™˜$iÀÉì2k£•?·÷8¿Xj`¸ŠÛ¢,­ òAü+9¦–‡fQ©$¤~¯þħø}ðõü{âO‹ñžueÓ']ÿÙŒÓH0Æbù>Py “Œ×m9#æ3 ðóÓ©oöøá?õm'Ç×_ØÚ€ÔšÂÑÖ#zÂdO-Éù‚|ß6ÑžÛ— ÕU›‚Ðφ§Š©ïlé&ÊÊÏM³´Ó´ëHmtûXÖ-­ãÇ jTE*€p®î}Tb¢¬¶-PQüö~ÛâÜþ×^=1BAm¦‰[Þ?ØáÁ㟺TsϘ¯OðŸ ÄO÷Ìòý~ÆKØsY@2yçÈJô\nŽ…^Zˆñ øvÞêÆöy®. CuÃ÷Þ‹ÏàÆ¹£ž½jöØý¤ÿ‚vü2ðd5ˆsøvÞoVâÎ-Zé Ë xX‹;Ü@¥ÁÈËœ”¹z_Ãô)J¶·¼~“×ô§ñY‘~|Di-~ÓÐïË[à4}þ\:ôê:ÕÒø‘ÉŽÿwŸ¡üÜø¥ðüGý{†àü‹ÛúýkÞžÇåwûÇêOð±‡öm‘%nØ:Þt§Gá1Ì?Œr^"0ÿÂU¦™<P‡rœ¶åóFGBN~„û•…}™ëe?Oê¨tJñúŒvBÐ3àÏø(•ÓÛü Ó"_/!´ˆïb<›†ù@#'(89ÉÆ@#¯ ñžÿºŸ‘_£Xjo72G¿n»`£slûʪ>›¾0+§½ÛžI;UŠ?¦Ž¢¼³ïP3†ø›âÁà_‡¾5ñRÏ£é—h¡wntŠ {¶§®*éÇšiØÊ¾Â„§Ùφ™¨\Þ\\__NÓ^ÝHÓÍ3õ‘Ø’Ì}É$×ÒR\©#ñLlZ’“=M‚öú+—³·yVÞ?6RŸòÍGsí[Üòœ51oïIŒ¦ó°sŒÒlÒœ5<âîÞ×TÖ,m. Âîs]Á¾RzzqX4¥-OVœ§J›”w=×Á~!ñot¹ôx‡[Ñ4™ÈöZeÔÐDã,H ÇâŸÕéKVŒãœc©i »—ü-o‹jþ.аxÔ'çw¯ùtâªÑìWööc·´b¯Å‹Êÿð± ÛäðÖ¡& ü ˜ $¨xóA p£©¾{—]O×xg*ø5t>Ê®Cé€??à¥×&OŒ_ ì¾|C ¼¼«mùî\pq‚~N@ç¦zŒ÷àÑò\I+ršßðO[K{_þ<0["3èSït@ woÔç?¡úŽúcRQV98f¤¥ZIŸ²5æpüþ~Ü`·íeã-ÒNGØôà¢_º¿èÑÿ«ÿg¿ûÅ«ÔÁü(ø>#v¬Ï:Öp,É*J‹(2=r•éý“âµäÞ‰&´ÔrÝx=ÿysÓ=\Si¸°4…þ jq”@"×®Tlv$*óÀ<ô`Ôšó1ºT>ç…Ýðhûz¸Ï¥<ÿâ¼"çáÄ[v•—B¿B%mŠso ù›°õ5¥/˜å|<ýç ÄøþÁU %oý½ÙmcòZÄ~¢|-li–/ÚØñÛ÷ê©|$cÿŒrí̶þ.Ñnm"i®¢Õ x£A’ì&R¤ñ\õö=Œ¡Zq?ªÁÐ}+ÄgéñÙ @Ïà¢ñHß´fIv¬~$´gûãɹ÷äƒøWVã<!¿ÕÊ?€O~Ô_üÄ·`u«<-Úî\ì#¯Î žÌ§n¼N±>{$V¯úV¯(ûþ@Ï/ø×á«ß|#øá2?7TÔ4k¸­bÚÌ›ËcàƒÕÂŒã#9Ö”¥Ë4Î<}'[8#ùëÒnG–ªÀ«Ž#zú*rÐüoIÆm3©ƒXºµIRÞáÑe]ŽˆÞ=­isÙÜĽÕ>VËTÊFÔèêyõωNÕ¬çŠíà1do´€TŽ ÖZž<;”±ÛXøÿUº%®­{4ì3¶)]Ø 5~Ù.¦.œ¶‰u|e¬»Ü»¿i!@Òà¾cSÈ-è>´{x÷'û2§òŒojʉpo/‚3Yw>€è®£ÛG¸fÔ_dŠê¢&i./Dj¥òÅðª úC¬»”²ÊŸÊqW^'¾©j­tehÔýçÎ9<÷f« éAÝå…Ò„R5´YçT…Ùµq­ÝMQOpïK¶5f$ ôµW1Ч©Î^êŠÿ­D¤tS£sõÏþ ûáûí;àî±â Ûw5íjk‹Va6Þ8ãˆ0öóaøW‰Œš”ì~¡ÃXwG ÌúŸu×ô@Œ_ðR)#—ãÃ[rT¼Z 9 I`æ@ 1ò¯ ¯Gâi[”Þÿ‚I|gñä>f%“D•Õ6ƒ•Päç9ãpãûc›Ç/uœ*ÿ}#õþ¼³ïB€?ŸïÛ‹aý¬üaå±'ìZppNv·Ù“Žœqƒß¯à=LÂ|žq¬3 "FK H°?í’שöO†ñä~ù"¿ä6ãÿF%sÓÕž¾+d~â~À’G'Á\"`¦¿r¬vãqòmÎsß‚}±Ú¼Ìoñ¸á÷Cî â>˜ò_ŽÚΑ¢|ø‘q¬kzt3h·¶ÑO{p W™à‘QVf 2Iè ­h¦æ¬pæ3Œ0óævÐþp¼E¬ÚI£, *™C±ÆGÊ?½¹=ËhÒj£f¯ÃÙé6X(˜‘Û ¶­]/„çÇ/Þœ>¹^x¿D³p›gÕ B%;WU'k`sýÖú•͈zÞP½øŸÕÈè>•â³ôŲŸ™ßðQoŠ~ À  ÕÅÏŽdÔ­¯¤ÓmAsm¬Ÿ4ÌÕÎW Icvãæ˜XK›šÚ5Ÿb©J—±¿¼~Vüñ†‹áOŸ ‡3Ã4ÌmK]„#~ðÆ¢S7£‡m¤~™þË?°ÇƒŠÚÖÏ^ðœqé·¶v‘,HPäΨ8b«Ó÷‹&¯IÓûŸ¢ä8øc0é-ÖçÖuÌ{¡Ó“@›¶¬ü ý¸~$xcâÆ­oÜÁ«iš–4ûZÔ.yÄÒ»,rä‰C. ¹fÁlש„§(«³á8‹F´Ôbö:ÏØÇâO†þüSÖ®¼kª+FÖtóg ÄÛ¼…œÍ/šG 6†Û…ÉÉ“Zc)Jq÷N>ÇPÂ×j£µÏÛu‘Uу# † ŠñÚ±ú:jJèu?ŸïÛŠá¥ý¬|e[–5Cß<}™x9;¹b¹ãîãdú˜?„øN$OÚ³Ì5†Û`øËk ŸÝ-zoá>+÷¨òO4°Ãv²Fé¾*FNõ8ü?…sÃCÖÄÚÚ¶Ÿ°»¡7ÂÝ_ÑêÖÇÄqê×ré¥Âΰ”…D›7S ØeûËÊž•Á(J:4}MU*êð•ÏÌŸÛãx³Å6? t ÀÚ‚âçVh˜q}‚"qœD¤’3‚Òr35éàh}¶|Gæ—V¦ô[ŸjrÇm(Àt¯FZ#ã(§)eke¥=숟fL®ûǹ?Ëó¬»=IOÙÅEn};û)þϱ|wø³j5=Wáφv^ë  vÄþêÔ`™ 击WäµË‰¨ ¬ Èð/>yìèE@P@ åz••êP@~5ÿÁM¿gb­gûDøJÎ_=¼«$Y €-îNË€$ãˆpÉ=T*?„ðsl"½KÔü}ÓuW´¿¶–åÚK^Žä/¸ÍvFVzŸ7VŠ”[ŸMh“Ãqm‘`©®è4ö>_YŸEüø¡sðâV‰âÐY´IØuhTg̳‘†æ¹ ¬€ Sn@cYbhª°·S·$Ì^›~ëÜý×½ñ¦èÿðjZÝ…¦‡å Ž¡ur‘@Œ†ó…Áç5ár»Øý]W§È¦Þ‡æÿíWûnü1Ÿá—Š| ðŸÅ2jÞ-Ö£sßÙ[ÊYÁ'ú満ìÑo@c'óWÓF„¹“’ÐñsÚ²”)Jò?&ôMV8Ò8þU € 8¯VHüûIͶvw:ߒͧÍs‹lì«å¸tÎy*G ÓŸ¹Éìe¬~ßþÆ^3¾ñŸÀ­MFv¸»ÒngÓ ï3JîˆC&âÜ‚DP2xQŒt&**5Ôr Ò«‚‡>èîþ>|zðìÿàÆñ?‰Y®µK¦0iZ³>¥>:.~ìjgð£ ̈ÙS¦ê;#¿Œ†›œÙø)ãÏxã_Ä{â‹ mWU1(²ÓÔ¬6ÑGƈ»‰cò®I'–$àìСȬ~kšæ¯QÉ£n ê:½½È‡Í’;h”Ä>äjî?¥vrŸ:ë¥+œ›i£Ì¡×Ì€Ÿ¿ŽŸZŽNVt*þÙ‘ájžñâÏ Íý•ªÙº<_ef Jã!'r¶>e'$Rœ#R6ea±Up•UH3öŸÃ´'‚µŸè½õÃÚ^ßYAs5ªÃ,‚xÕ™ù°IïŠòW?DQåWZŸ†þ:Ðïüâ¯xOT·’Ú÷K½šÙâ—$•V;XåeÚÁ±È`zõaQN7GÁâ°³ÃÖtæµFf{-ÌVæãn##@Âd‘’=O^y­!ÜâÄ®ˆÞ“M½Ö§™,­^y6r±®J¢Œ’}ªå©…'Êx÷‰m$Ÿ.sMÆNç àÿkß >!ø?âG‡ã•oô ø¯P€BΊyccÆ]‘ò¹çšã«£épÕ9¦™ý4üpø¿àï…u {Ä,.Úþ·²Ò£r’j: =Qq’Ï”zœÃF”§;#ê3,},&Ên÷GóƒâµƒMžÚR¡B¡ >¹¯^jѱùÅêTæ]O7Óîîní­ã†®.çqP¥䕋mUP9$œXóY]ž¯Õܧʑéž6ý›¿hßi–^3ñOÂnËB»¶[‘sB²Ç·vn2ÍnÀuYBF¶Œžç¥,¾¥(.hèrüQâ(5û94k««MB¼][Lм#Ô2A÷­éûîÖ<œZxxó'f} (Yî¯.%žövif¸Ë¼ÎÇ,ÌÇ’Ä’I=I®è®T|½YÊ´îÝÎ]»–þâ=>ÕÀ’CÇ£¹ü«);»#²„8ó15].=:Í"ÒîÕ™¢œ+z޾ãŽi5Ë )OÚMsÐ_ì·ðãÃ_ > x#LðåìˆÔìâÕ®õˆ”jSÜ"Èe•[f ªPÁAÍxu¤å7sõL¶…:x¨BÖGxP@P?ˆ4=7Äúµá½f?HÕm&²º‡8ó!• :çÝXŠiÙÝR qqgòÇñOàþ›á_‹<áí}/´-V¹°¶Õ•˜Fäló#ŒG‘ÁêRƒœn|;%YSZ•|¨I¦_\x~ò@g¶8FƧb=«¦”¹_+<\e5V>Ö(ö«w€TŠêѣ’iœN¡¨ÜXO­j·—–¶-µª^\<«ið#Œ1;0£¹çN)ÜõðøÊµb¡}„ðÇÂ/ˆÿO‡þÖõ¨ÚO,^YÙ¹¶ÀÎrhp?‰‡§µa:Žìõ0غX·‰J5ìzŸì½ ü(Öþ/YÞüzñŸ¤xcKU¹´Óõaþ‹ªÝn¤ò:˜Ö%s+¸íÕˈsåÑöK+©ûÉ½Þøgð§Â†-[À~ð¶g@é{¡é–ÖæDeà‡FAS×<çÞ¼ÉJOF}Í:4cïA"?|aøMà«öÒ¼_ñ+Âú6¨¡I²Ôõk{y”7Bcg ¾1B„žÈU1T)é9#ñ{öŒñ÷†þ)|d×üIák >?Ù…²·¿´µŽ)5=™/<’*†3– XŸ”1¸×³ƒ¤á½ÏÍ8‡N!ª >}×5$µ·r[G&º§+#ÃÃÒs‘æš&¹jnî/\Cq#†_!˜‚«‚àç9çò®xÉnzÕ(¸ÅFÅ}_ÅÛ£#sÁÁ'Ñ9ت^i#úSýœ4msÃß¾hþ$ŠênÛA´÷Ù[±Œ©U*P›HÊíÚIÆO‰QÞLý7 Œk¨:€ ( €Ž RÙŸË—Å;]O¿þ&x[{í›=vù&’ç%çÌìÂ\•ƒ©p`qÍ{ef4$«IHó}{s?WÓ-Ò-BÀaü¶9¹L’wg<àöü³W%­ÑÍKgN[3×|=«G¨ÙÃ*09¿zé„®EÓ“G}¡k ëšˆâ±µ¼ŸJ¼†ñm/£E9Ãlu?Âqƒßž0iÔÿÁ@þ ü‚ÓD¾øYqá¿üQ³ºKKÿ h ‘-Õ±·ÍoÛ ˆYX3Þ¬À—*€vaÕI¿#æóЏ<4nšæì|màø‹Ã·ZÕž¹yc©[6è¯ì¦kV…±ƒ¶E!Á=pkÔ… «Høñ„5[{ýîXdK»E"?=aŽ967Iº1Þ>VÝO }ì4%K˜ü›;­J¶>R¤î–/5IíÕ–nƒ¸ç5£•ŽHRRØàõ }„¯5¬§Î„o;y sÎ=89¬\ìÏBžêÒZ3kÿጕ³D€ág^U¿­\+_sŸ–r«Àõ+{ûB’ QчNEnš{T©N›³)^é°N•S4§VQz‡€~!|Tð~‡¬x[Ÿ5½Á÷*Ë%…”ûBüŘÂÄ„’NLeKsœóÏõhMó4z¿ÛXšýœ%¹æº‡‡ÍÓ\\ÎòI<ÌÒ<³6÷v'$³I'©îjý’KC“볓¼™zÛV†ÆÜC>"‘F=öàÕ©YJ“¨î`ý–¼ áߟt øS³.™ ëW:eÉV:²ÀÉ‹eV0feg\sIõXªÎ1Ðú\‡.j«Ÿcêß‹ÿðKû o[¿×¾øâÞîc/öµ<6¥œ–ÏÌAQ‘ËËœñÅK[ŸO_%Œé¿‘ùã ø›áwŒ|µ—V»iȬ@( € (øƒã¯ü4ðn½ãŸ\<:&•›)w;±`ˆˆ;³»* àe†HÕB.rQG>+5)T›ÑÍÄïëxÔ’K* ü@Ö3ÃA¾fK â©Ót£=ÈØ®‹`žeº «–ùšyþé'© ycžäþ´b£±çÖ«R¬½æTÔüD/,û˜ žƒÐ‡4‰… Lò|FL4†igoºˆ0¾ãÇåšç©ZDZ„Ë}¦¯c†Ó|]öé…ÝÛߦÑÐV1©}YèTÁò.Xž…k¬ ÐyD¶}+e.Ç›:<¯S¦ÑBM7™>v3gA–Eî@'ÿœÕîŒtŒã}®IžÖ|=¯øcBÕ¼){ׇn-£kI£,Aw|ÀŒ`†äAäùê‘q“RÜý‡ V•j1•'uc¥¨:O‘¿mÞø+àüÚv˜Ï÷‰®ÓJ3FåL0²»Êzs¹#òñ‘Ä„ö®¼%:—}âL\°ØGï#ñgZ–O²Å*If‚Œ’>•íËk#òê*ómžQ¯]ª$™njç›=Œ<5ÕF};äzž?JæÖ÷=»G“”µpо>àê3Š{Ìtž³Öµoh|Z它a©_Ác&©©HD¢I<ÉŸ”g<ã…<ÑÏ(«¡¬5,D•9ª?bßü8°Ö¼Uà}^-ÁV6ÒÞN·Ž^ØÄ™ËUTPK.Ö<œd”±ª^ì‰Ì8jXuíh»£ãí%BZBõÇ>µéGT|moˆèbÑnolïî  äYÆ$³… Àêy#¥6Œ£-O4Ö,‘•ò+#У6[øª_øCöŽø-­hÅVõüIebrîŠêAm*óÀ&)¤íœñ\5â¹Yõ9Ef«E£úxå -Èÿø)—ìýo}¢ÙþÐ>µŽ;ý;ɰñRÏ…c·ŸåÕÝb'$•hû%uaê}–xY¾ëÛGæ~s~Èÿ'øñ¯ÃÞ'¸¸œxGPìÝnÚ"ÄIk!ǘTgq‰ÊÈ;JŒn5µJ~Ñhy˜,WÕª&ö?¨[«kë[{Û;ˆç³¸E–)ápé"0ÈeaÁAçµf}|d¤¹‘b‚‚€ ( ÇÿÛ×ã,>-ñnŸðƒDÃi~˜^jW+.D÷¬„$AG²I't„avÞž—;>‰si}^7<'öJø Ÿ>3[^k6/¼.ÿQùË™Gú‹rØÇÌãs)ꑸã9bêò+-Î^Àýb¢”—ºßaÀÅyèIYXü^ÿ‚ëjÿüáY¢Åž‘¡µämæn ÷3º·Ë”âÙ9Ï– ×>3‰«µ%ÇÈ~†xÒ5@¾¸¯V Ççø™9jz¡Ó®-4Û NSÙ®Ëö¸-òœŽ¢¶<Ù+œÞ¡220ÈéS#Zqiž…ðOönøñÆâöóC¹³Ò¼itm®5«ÇÞV@ž8¡S¹Ü,ŠÜíCœnŠà¯‰T]ºŸ[•d•3§²îxwíKðÊëàŸÅë¯i¾*ƒ^Ò–ÂÚôÈYíԃŽò¦E\ÿ«’2zÖTëJª»=fYG.DîÏ•µ{·½ÔL2 -¸Œ` ?çÒœÙaÉ ®£a³óc¹…×À»ƒ×?­+R³Lï<=vV5Š^F=«h3ÎÄÂú£Ô|=<Ï$û û&AöfáÏç[ùåb,•ÓØGÇ×öÞ+ñë‹¢Ú=ý›jVбâ+ˆÙöúoFÿ×!øñfÓJhúžÆÏžXy=ÇêMyèGÄ¿·w„µá&®é¶‚qáíN;»­ —KgG™qØ;Ä[ýN@ZíÀÍF¥ŸSæxŸ *Ø^hô? sŠx¤+4d2ºõR:ö™ùŒSLóOÀ—“Ïu8\ÈÅÚFêÄõ5„âW6Ž_¾OxóÁ^ ðÙ®·ªÛX=Üò¤KI"«9f8áI8îF$\µ4W=¼ö³QgíÆ¯ø'Á{Â'Ô~hWº'Žb´–ãO·¶¾’[k«…ˬN“3€«(]ÀàãŠåÍiS_)£ìÛ¤¬ÏçïWŽï/m#¿”§&"Hê=y?u½O§h?3ú0ý‰>3iÿ´?ìî¾ñï/‹¼;gÿö¹«ÍÄ&6H'³oó!36 •%ùBíÏ ×$î}V¢ÅaÜö?,µÿjžñGˆ<®¡M[F»’Òo•”I´à:†ìuÃ)Ç*À÷¯vŒÔâš?)Ìp²Ã×”$R’ëå 1^µµÏ>09Re!ŽEe&vQ‹;¿Ù?¶>8ý§~iwº¤qi×ÇYU‘Ô=ÃÚ)"XÌ^4$pB`A¸1R´YõÙ.jñ¹ýW”}ù“®èšW‰tmWúåŒWº6§o%¥Õ¤ë¹&‰Ô««B Ó³¹‚œ\Yü³|wø3â_€Ÿ¼GàyíçžÒÊo´i·Ò®~×b䘤$ +•l W«Ò§.eÌŠÆÑT*:rgÕ??à¢?>h>ð6« é:߆´¿ÜÅ-ãL—^FNؼàÅT(!T˜Û`ð"tc7s|>i[ ‰#öƒà‡Ç|vðñ?…¤’ ˆA¥Ü•ó¬fÆv¶ ‘ʸᇡGZN›³>ާŒ‡4tg²äzŠÌíæ]Ã#ÔP˹âè Ð5OxŸS‹OÐtèüÛ›¹²V5È$’HI$U¹;#:µáFrz#òëÆ_ðPßêӧïi¶*åRãÄ>eÅÄ£ûÞ\N«öÝ ã©é^< µäÏŒÅñT”œiGCó—PmzïQ¸–õ®/õ½VèË%ÔÇ2\Í+d³“Ý™²Xõ'5Ú׳‰òêoVïv@³oÁËo‚Ÿ ´o K ?ð’]}¬Ï"[ÇUÜ¡»ªásœW‹^§´“géùf `è(u=ò±=ò;þ MáKKü0ø†·q‹«ûY´YmÞU V3FÈ™ÉÏ(f( ô0SµÑñüOC™Fhø/LºMªAëEŸžÕƒ¹Ñi:¦Ýç§=+KœÞËSûT[-ÍD¤‘ÑJƒm$~Èü´´ýœ¿eé|_ãø%Ó¦X®?ñv»ãŸºÉâ ríï®YrB8HÓ$ˆ "‚xUQÚ½AB)#ã1X©bkJmŸyþȱ'>*øKRø›ñWO¿šÓQ»Xô‹K{‡¶C+$ŒW–W”rò‰xW"³Œ­é²|º5èsÖZt>mý³~x/àÿÇ©¼5à{{{OjU­üzl3´¦ÉÎøÝ»³äùBNqă3Záææ½ã‡8Ãà ;SØñ >ÙÌrRËÈ'œWrGËÕ©$vñÞÈK<®ZFêÇ’kE¡Ã4å¹÷‡ìáÍKXø¡®x°Y9Ðôm.Hìð¢ægMˆ9äùk)=p1œnÁލ¹yO¬áL$gZÚ#õ꼓ô2µÝ¥µý­Å•ä+-¬èc’'¤`ƒøSM§tDàªEÆKCò«â÷ì âˆ5 Ý[àþµg{¤O#ȺªíÖjq„Šs¹e-÷ö‚\ä×£K¥¦|f;…ß;žïÐø¯â_ì¿ñÿáÿ‡gñWмöM V)®¢½·¹n8Vq±U'qÉà‘[,D*;EžeLŸƒ§í*GD|ûaáÓg3]O!{¾•xÛßåôí[*}Ï:X·§.‡îìIûCÅñÂü4ñmøÿ„ûÃ,PI;(mVÉFסi##ðI’Y¶ù˜š.æ[s’fkKÙMûÈüìÿ‚„ü²øeñ2?x~Ý"ð׌škÃo8¶»R¾x ÆEqÏW#ZЗ …D®œ’+5´ã#vÑÈGÁeÈé‘ÕMxõ©:r?F˱±ÆÒRëÔ÷£Ò²;ÙüÚ~ÓÚÅÞ«ûAü\¼ÖeœÏ·qk»nV[ʈ/ ±hôÇ'’}z *hüï5œ§Š‘ñ¯‰lŽŸx #ki×ÍŒ¦~A“òœ÷üˆ©žŒÓ%8ë¹ê >$øÂ:Œ0é¾-Ô´EÔá6רÞOoæxyg,¹ãµpåvæ1¬ªSMÑv>Œ_Œž>Æù~0x‰™Iq¿X¿$1É'¯S¸äûŸZÙS¦º\±xÆþ2I>8xþERÿø‡[bÚΩ i÷—lË´™¤·Ü‘Î>f€=ªÌs\ÖXš­ßDylv:½ä6qË|ÓȱÃZWf8U 9bIÉ=«gîjÏ: 8—h­Oz±ýŸ¿h BèØÃð—Äkp.ë‹_&<“õŽBcß8“ÅS]Nåâäô÷gìýûÉ¡êvÞ/øÏöK»ÛY#šËÃö²ù°ÆêÛ·\¶1' aWKgо/›HO•pê¡%S¿cο࡟Ó\×<;ðKDºck¥Õµ¿,ðÓ²âÞAþf•”‚?y *iàé]ó²8 •?SóëáÇÃíkâ×Äü?ðêwª\Þà)+kn¼Ë3 'ž§©×Zj ³çòì$±Uc~ó|Wø—àÙOàÍÄI%¾•k—¡è+:¤·Ò(TEŽHQóÈü¡Ž À>L"ëLýZž]‡ô?žïÞ뿼M®øÓÅ·òÝø‡W¹{»›¶síÑS$áaUz*¨QÀ½jtì¬~y‹ÇJ­G&ÏLøSð;âÇÅ;bßá÷‡¿µ¡Ófâf¹†Ùcó ¥¤e°àp‡Øu£GâearúÙŠn”v>³ð/ìñ[Ô­ÓÆ·Z_†ôPAžQp··c8Ž8þBs€K:ã’7cãb—ºz8~¯9þ÷D~°ü4øká_…Óüá#N·ËÉ+ÒÝÌØß,­üNØÀ P›R£©+³ípx:x*j5¡ßTa@gêº]†¹¦j>«j—:eô/oqo'+,n¥YO±Ši¸»¢*SX¸IhÏÁÏÚOàM÷ÁoÝXÛA3ø/RfŸF¾“Ñð^?ߌ¶Þy+µ»=¬5eVî~ae²ÀVm/qì|ÿ¡x‡_ðO‰4_øZñ¬õý&u¸¶¹A¬;Ñ”‚U”ðTx&´©5fqàñ3ÃÔS‹Øý—ñð¿í»û0j2èÖñÇâ/,²ZÌ~m/W…1–ÁùH|Ç1Ê8JN…K=Ðg(f¸>h|GóÊ–‘éšëèŠkGddu «ŒŒíÏZîI\ùY¹(Ù³³÷íñáý'á1ñ CÖ/µ="?°É¬é^LË$*TBÎŒèÁ„yVÆâ|°Ãqr ˜G6åØÂñ 0ð*ë^çéG> x?âg‡­üQànOF™Šy±†V‰ÇT‘F|¬Á¡ñN¦ìϧÃâibà§IÝ7~׳ú|ZðˆñO‡­—þÿÂïmƒ·Û ³Ûž9n¬™èÄŒ€ÄÖøZö<Œ÷,XÚ.q^ò?¦·K¨˜2áÇHäzö•¤®~bù¨ÎÌô¯ÙÓã¥ðâmž¸©$Þ¿ÓU²RO™nXe\ãÌL\ÿ´¹É®Zô}¤l{ùNbð•Túu? ýYÒüC¤iÚö‹}æ‘\Û]@Û’hج¡¼wf~• ±©8½ç¯ö™Õ¼ã?Ž?á^ªTƒÈ¯&IßSô:2‹¦œv?*ÿnÚOx’o‚þštð¾ƒtFµ8;WR¼M¥c¯— Îxiqò+G BÞû>7ˆ³kßMéÔø¶c²·ä`â½Mð¹Èýýˆÿgá¯ê|kñuüJì&eÐmfS‹‰×ƒrA*„‡?}Iãb“åã+ýˆŸuÃYNØš«ÐýQÔ5 "Â÷UÕ/ ´Ó,á{‹‹»—ÇH¥™Ý  I<+ÍÕŸo'+½€<ÿø=á»›ý;Áº.·â»¨ Æ·–±¥½›°Àd‘ƒ²ç<„ÁÁ A=ÃNZž.#;¡M¸ÇSñ—Xø‹©x—Uñ‰¼U{,þ+Õîd»»¸›€Ò9$ìç……Q÷@` ôéÚœl|N.3ÅÖu·?Sÿ`‡Ú€¾x«ö˜ñÝô66Ú…¼ÑYÜ]  c¦@Ù’]Ýs$ˆFÎ"P2[ÏÄTu%ʭɰ±ÂQuæ|9û@ülÖ¿h_‰·~"¹•×ÂZsËk X(-í7¬eç÷²mVsì«ÑEvaèªkÌùìã1xªŽÏDbøÀÞ ñ爴xGOûf»¨1HaÜ@U,ÌÌx ª 'Ðw8ÓRjœnÏ ‡©¬©Á]³úø=ð«@ø;àm'ÁºJÍ ™.ï™K{;Ï#°w'j碪¯jðªÔu%v~©€ÁÃES‰ê_fv…P@y§ÅŸ…¾ø¿à­GÁ¾#JD¶·ˆ Éep ì•3Üd‚;«2ž ­iTt¥ÌŽ~ ê.”ÏÀˆ¾ñßë>ñE˜ƒXÓäØþ^Z9Tò²FØF\x<à€AÜ…EV<Èü³„©‚¬éMl\øñÓ]ýž¾"ZøšÎI%ðû%¾»¦*‚.íòpÃ#!ã,]HÇB¤áˆ<Õ誈ö2œ|°’ò>wø¬ë^=ñ—‰|uq¥Ãî»y.¡<6ˆ"E’FÜÁTŸRO$Ÿ^hPih9bcVnRv8Åz†õA–’.d•r{7ÔrE¨âì°°ÄBçÝ¿²í ÁÿŠö²x“TŠËÀzüfËX–Häeˆ€ÍÁS'rÉòç•øèV10ö±Ós£%Å}J·,ŸºÏÜÏüXøkñ"Ù.|ã]'WV@æk…ó£Rùâ8t?0ÈeÐQßL·{±F½¸<Ë3 Ÿ™Ü“Œœ à ñ*MÎMŸ¨á0ÑÃÒŒCÓ*  € ‚æÚÞò ín Žki‘£’)T2Ȥ`‚H ÓM¢eÉY£ù†ýª¾ ]|øÙ®x)ín¤ðmÙû~4§pšÒOáÜ9-oŒçŸŒ ôiOj|^? °•!ê??j|"øQñàþ€%–=PùÚ¦³±}Yp—*>l€U|ȶVv;²i¼:œÓ!gÃáœ:ô<ÿEÓ£³Àq^”#ÊŠÄV•Y6Ïuøð‹QøãñÏÃh²Çá‹-·:Åìd¯“oœlVÚ@‘ðBƒèÇøMa‰­ìã¡êä™kÆÖWøVçîuƣ࿇>´†ÿTÒ|=á6†&½¹ŽÖ xs¯¥x–”ÝÏÔc*Xh(Ý$ÉÛÇö¨ð¿Ä=#AøSð§Å‹¨è’Î×Zý圑Íå!· T,±–-!*Ys|ñ]xz-;Èùìã2„áÉIúŸ™·z…®™kåEŸSqò@Žªõbk¹µ¡ò‘§*’»zEûkº¤7/=¢Gl¼ƒô9æ²—4Žú^Ê“VzŸkøÿö£×~,|øGðrÃNm'Jðõ„6úØ…DI¨Ín<«uTˆ–4WaÐÈã kœèÑ´œ™×˜fmÐ(èy6™§2yQÃI<¤*G嘞u'Ò»Õ¢®Ï“nU¥Ê·?ocÿÙûþG„¿á,ñ-©_ø‚i¢‘Mµ;Ymˆ'ïäs€waƒ'ÈÅWö’²Øý"ÊÖ —<׼ϲ}kú € ( € øöüð/…/~ÛüE¼x­¼Y£\Ãghãõ¥“ oɶ‚ÒŽ¥BI¼k·Q©r­—â\%*”=³ÒHü}ƒA‹ ®×l]DG’~µë¨\üòXg¤MI†Îñä2­Ð ä"((ÜüÛ»Ž:b‰E yIž ã}.)áóàÂÏÎB2 þUËR={U§fa©d…i7Çlsš‹>ÍÞö:½ÄQYo‹P¤‰€ÆJþ¤dºœ•¨Íëcè]ö€ñ힉©øsNø‰¨K _Û›iôUÖöˆ€ ¬WÕx”ŒpF(ötÛæ%âñ” é·î³›Óõ§‰à’E2 ¿½tÆI«-JM>câ庖 ¥í_– ÎãøÔµvkrÆýH¯§º°’ÞëCgw‰cºF"HÜ‚¤ciuý*f®°õ%ÌÙúcûþÙºæ½â /ƒ?õ4ŸQ¹F'‰.å"K‰6÷.äîr ”rrHÚrJ×—ˆ¡Ëª>÷'ÌÝ_ÝTgê~,ð´°5Ô^$ÒžÙA&T¼ˆ¨àœç rr³è=¬;Žøf(å•üE¦,Q$v»Œ' 'ÆßÁ÷v—uâñé責Égà=ÄŠ8$*©Àf=°­¨Ñs–§™™æÂÒ½7vö?¼Sâü@ÔîµÏë÷º¦«r1%Íì¦W#9Ú ûª;*á@à^´i¨«#óêøÉÖŸ=GvsºV•tÞbí†Cç×Þª1³0«QÕŽ‡ayªÁon<·Hà©ëô­\’G:-ËRׇ¾-üQ𮉩xsÂ~3¿ÐôkéŒ÷ém¥™Ê…ù§P%#h.ý£’,ÄóNœfï#ÚÃãjaaÉMØóí@ßêW3j:•Ô÷wód¹»Ë$§²OOAMA$g,LêJòg¨Í•âHò Êíe•î8üj’fôá:‘ØâáIoõÙgwv‡w˸õPx¬Ö²;%jt¬{ztOcN¹,Û¿ õëªÚ,ª>fБií§Möˆ#?‰¨¥nV§´Vlû÷öðg„~ |OÖuŸÌíªxJ/ôí*HÎÙ¥g+ö‚ÙÇõi¿„ŠäÆUj<¨úÀÓ©YÔžëcö¼³ï’°œó@ @P@ðwüÆîëá†'„3ZZø†U ͽ«“ØÛyê\{g·ýóæ8¢2x[­Ê[ ˆÄnT´ ‚ʧc^âgåÒWf'ˆï-¤šçìP˜íäsåD[qPOžç§5gEëvq§…,ª\j72_ É ëÜ€03XÊjwÐÅ5;%¡úßû'ücý”ué bðžŸá=R+†”èž-0Ý.£pÇ>twr(Yœ ãnÕ]ª¤ùU©Ô‹¹ú[ŠÁÖ¦ ’L÷ÏþÄ_³_ŽRf›áݶ|ä‘wáÉÀ¡8Î"OÝvPãœu5’¯8õ;ªå˜jºÛSäÿÁ,¸úÿ:Ò0QÒÇ-\Lê;ó2ãèWç%4ËU^~ó)é×ø‡­>UØ…Z}d̹t-`r$GýsIÀÖ8‡Õ¿¼âµ .â ^¼Áv*:gÚ³q³:U^jg[a§òÕSsÍj‘Å:š–µÝëMžk+ûf†éÍŽW½B§QÜò]wMÂ1Few®Ö#t5„‘êá§wcôkàGì¯xãÁþñÏŽþ 3OÖì㾋G²±Y.Õðì)û?ø`[M©èº‡ˆïá0O­Þ¹RxàÅ—(ÁùY[©ÎxÆÅT—Sסá(êãvmüKÔe¿žÖt/x[–vZ•±†O ézu¹ºÕW aE ÀçýcáA9, Í(F¥W¡¦*¶ M©Øü<Ö>øg[ñf¿â?i‡‡¼5Áû¶©wç›Dë·Ì œä„Ø _­NƒKÞ?>ÆfpœÚ¤¬ŽrÚÒ MFkAwöË[y6¤á|¿9}qÎ*Ò±ÇR\Ë™ úÙÏ4ïgCjÌvDHô'½[G:gÙðO-.ôüuñ£m}Š\Gq.ѾâÛjäq’PdoJóñ¶Q>¿†9¥Yµ±ûU^Y÷¡@P@Pãïè?ü#­ø3ÄvÂ]/Q„ÆÄš¤ˆ{2°VÔUÓ›§.dsbðÐÅÒt¦´gâÅßÙßâÂ]ZúÒç@¾Ö|7óañ“g,¶ímªeÀ>L2Œzž ìÒÅÆ¢ó?4Çäð“n*ñîx.—àßøÇWµÒ¼'á[VÔüÔÿG³µwÆá¸o8Âw1NqU:±Z¶a‡ËëU|‘ާyñ á/¾^[ØxÿÂ÷:d³äÜ>Ù­ç8¬s!(Ì3ʃ‘ÜUS­ »3<^[‰À?ÞGCÈõÞåpÈpG5r‚g=,DéÊéŸJ|ý±>.|[MU™üaà8ÄÒõIȸµLõ$3árÀ Ö¸jáµGÔåüAR£ST}·ã/ø(ÿÃ]#J²“ÁÞÖ5Ýre&{K¢¶1Y0$ypûÛ€@E#–*9£„“zžÕ^#¢ œÙù³ãŸŠ²|aø‰âoÞipi—z¬‘²€–X„q$Kó§l`“ÆI< ôðñTãÊ|.oYâë:ÖµÈa¹òŠÉ…$^C)ÁÖ™á´îbjRoìÙcÉ$Ô3zg–ê÷Ñi×v÷r©)ç©àô®y;;ž­n¤\QÐÚxÚÊX|ÈIu,£ªýAéVª£ `dž¤ÑxæÒS•†]¹áŠõ£Ú¢­Í ?¥ð“ÉC¾>¨Üš©s9á ðjSÝÛÉr¢8ãBTù­‚HìäÕsè(œô³Ë.©“  ´¨`sžjo©º ìwVR¢¢p{V±gŸ5¨ûû†ŸsË!w#–c“ùÓl Ï:×c†YFR °ˆp_à}kžg©…ø“gêÂ?ø)o„õ;ë}âgG…´’[jÚDïyʲCå‡PrnÉ#åP3^TðÏtÏ¿Ãç´ÒQœlŒ¯‰¿·?ãóq°®NôpIë#ËÌøžQ¼0úyŸÌÚ}µåÖ±®_Íâ/NÂK‹ûù䕆9yï˜àc$Çñ ô£N0VGÄ×ÅUÄɹ=Lkxà‚aÁHæ»ÔãQ^'ÈÏS 7ªÍ­Í†ÕÌj2ªqéCŽ‚[È’ÊÙ--Ó×p¦‰¨Ü™sþ¶-òʹ%A z|ö#êÎZ£Ûþ|ñOÅëû; Ä^°ûRïSªk–Ë62 ³FÏ>ã¼ `g‚EcVº¦C”Ï$›I§z'ìð*Ëá_Y]ë:åˤóx‘¥]G ƒoÅß!ß÷¾bÄ)dñ3r¹÷x|“ J—#Õ÷?,j_؟ų֛Œì»pÞQ´fzÒ!•ˆ©Á ÛÛ#®Ó¶¸eŠ›wGÕÐÈp´©¸M]Ÿ|ký—õ„·réŸ<+}¢Z+]cYµÓ/âLäIÎÒ¼£Ç¢ ]Ôq|ß>W1áçFMÒ’høÚOXÉ+[¥Â¼€€vœ¯#ûÝ^ƺ½ªg„ðs†è©x†åD™ùÇ̤Õʃäg&,Ñ®/Q# “ã 'õ&³¶§g´²Lêü/ªêV#Í%ěᵌdyÇG$ž09çêjá.MÌ+QúÂN;Ÿ¡_?büC:ïÄy'𯅷}ãÛ¨Ý(ÿ¦l1<àÈ q„k–¶61Ò'µ–pÍJ¶©_D~¥|5øKà„º,zô,¢Ú<ë¶eÅÛu-,§æsœñœŠ6¥YTw“>ã £ƒ-(Øôrì fu´žè0@(¸(¥²…P@P@P@ùÑÿðÔ×¾øy∭â1iºŒÖ“KååÐN€¯ÍÙsîJúïÀÊÒhù*¡ÍF5"¶?-…¬mÜ¡—¸õìXüë¦sìL³\˧B¶öìIK|³ˆ‡ $äþ5“MlvÒš“Ôó×7 Är3=ÄÒcó {VGz¶èô tŒF€·Áæ´I3ÎIÝ3Ñ<;ñOâW‚ÚáOkÚlq•+om¨J!ùq€b$£€0TŒqÒ¢Ta-ÑÕC2ÄÐø$uŸi/‹þë|u¬ÙêºEó@ââ[$†x7†F‹j’ØÁܬ1ÐÍf°Ð‹¼OBYÞ&´=Wt|Ï¡i­i›vPvž Œ~5¬U´<êõyµ:›ë;A¤]\Ép‚á*Ú•9e ’ÀôàŒc¯5oTaNo›Fv?¾7üDømâ¿ø@¦Ó¡½×–ä¼¹µóå·X¼Â¢-ͰdÊIÜ÷Wç<Ó¢ªZ糅̧ƒ¿³ÝxÃã‡ÇŸˆR3ø¯â§ˆn-Øî6–wFÊÜžÇɇb}8¢8xÅè‡W8ÄUV”'M±g)ºG%™Ûǹ&´TÑÁ,\›Õ””Ð]K\oÃË~Trا[š'Ueaw媼ًéób´QgêFú#Cû2Þ-þR¬IùŽOâiòØÏÛ6Ï®ÿa M¬~Кv¨¶«%–…§]^O$±T,¢B¾ér:+c¡®#|$ø›ð¦;Iþ x>÷H´ºeHnæ $ì %BÉ¿ Çfw`+¢5á?…žM|³…Ö¬lyÎRk‘#’‘3X ½Î?:Ò.ç U¥ín+R×ÚJòZe–9d]ŒËØ‘ÛéTÕÌ)èÆøÂz׎õkOx?G¹ÕõéÕ™lís€£,[<(ÉÀéYJq‚¼™ßO [>Jjìú¯Ã?±ÇýyöÝøoMÐ`)¹n5B=§Ÿ»¶5ÁïÊXKMlztxsRÜêÈú@ÿ‚s]¼°É⯉ñ¬ýe¶•¦’ÍÃp²»à`í9(sÈÀëXKÙ­KZ•?ÑüIÿôøS?…5K/ êZ´1dCe¬j—^rÂêA!¢EE*ø ñ‘œŽ˜¬–2\×{NÃû'|]ÏÎü øµðÂúêËÅ^ ÔE­¸Ýý«a ÝYÈ›¶† *2Hù[k Ã*2+Ò§ˆ„ÖçÆc2|NMJ:ü!ðwâ§ÄK˜m|#à-^ñdfOµ½¹‚ÙFX4òmH‹dçiÏ+¶e†ÊqX™%Ÿ³?³WÀ ?à?ƒæ³žâ+ßêå&Õõ ynË»dQÁòãÀbÌÄ …_½gZ^Gè¹FYº•¾ÓÜú>°=p € ( € ( € ( € ( € ¨ VOq6¨è¢‹±r¥²‚‚€ ñÚàæŸñÇᖵ૗HuPEÞ—y&qmx€ùlpÊC27ívÇ8­iTörLáÌ0kEéø5âÿ‡¾.øe®]økÆzΛ¨Á#¢<Ñ2ÅtãÌ…ÈD<Ã×ð¯j•HÍ]—ãpu°³qš9Ø­/u[‹}/MµšïP»q6¶Ñ™$™Û€ª£–$ðæ´””QÍF”êI(£öö,ýš/¾iWþ=ñ²Ãã}zÙ`KA¿LµÝ¿c¶OÎåcfQ»@9 ãÇÄÖU£±ú6G–<$=¥_‰ŸxW!ôA@€õY>€¢à¢–ÈZP@P@P@P@P@P@PÇ_¶¯ü’sÿ_°ÿèk]¸OˆùœÿøGÌ_ðOŸù|cÿ\æÿР®Œ_ÂxÜ=üSõˆtå3ï–Á@€ ( € ( € ( € (ÿÙ endstream endobj 75 0 obj << /Length 4026 /Filter /FlateDecode >> stream xÚ­[IÜF²¾ëWÔÌ©OM3.‰’g4Ð`€Á<÷ᶬbv7ñXd™‹[­Ãûíï‹ÌH.Õ”Jžö‰¹U.‘±|‘ïvñîïobþ¾¿{ó݇\ìLdR™îîîw"N#•$»ÔÄ‘QrwWî~ÚëHF7·YïÿY4ÇÏms+QénT¶·Ç±»ñ¾¯Ú†ÛŸªáñæ—»|÷A˜åÔRD*N°°›t»CKÃÞüíîͯoÚãØÉDGZl@D8žÞüôK¼+Ñù])“ïžÜÐÓNa@ŽR½ûñÍ¿ýYV Ê$‹’,_Ÿ¥ö'ˆ>ùfÉâ·B‹Å[‘FI¢üîíÍ­ÎóùìT©Ûƒ?3Õ϶»o»“-}õð¼E€TD˜õëçW±ŽR™íÒL»Í¿âü*΢,MÝT*3×ÏŸÐI‡ ã¾÷tÏEç+C Ë©ínªNÜvl›[š~P‘Ò HйÁWnæ~ø¯'„IögXš[h›£í{g?¨·Š ­ fÜ?¶´¿§Å.;Z{+žÏÑŠæ¯Éž=9£öÌmXâvë¾ûÊ ›Êу¾EYú©í¸ky+Ë¡îT8õq¬ùŒ¾§kLJG_Ý©6d$Häán@¨¡è†ï£¡m´e´Hée“oxŸUsìlñ…5p“:âÂPY¬¡áR!ÃmŒW0JÐ¥tX†©PZ²‡¶qAV:T\ëõ Ø¥°yb¶<ö¾ÚܰS,—Øš cÒ0¦‡²ê®NU•àÑŠÎcû‹côÏ€2'¶õhµ&fY € 27{Çáø–UO’obVbh:dÿ¨tl;Üô¹ =N1Ôƒ‹žáFË#6A§*ŠÍêÎO›blätÊ·´’ٳذ–“õ^.u‚ï|¬xwá†=« ªB ­m‚—sø@U¡d‡Á3ÕœjÅ÷пp%§ñ~ÊX¤wbáÎG— #‘' 4/óx2u¹¸fêÀs„!œÛz‹€  aâ¦Àò½_`‹‚Åì‘5\Î(ÛGæÆ>>%˜ó —SÔÕÃ#ï›lÏæ‹å/6œ_Þø$Ißo ^M'oå[å—­Ò°Ò¼D´¸ß<2(½n°}嬂"ß íʪÛö¾á±Ôôó —½< ó3™ÖÈ+ð ñS‡ïùÒ’¨XÎQl^?_•§÷öƒïGB—4*`Œ åß‘ëqƒÊ`Æ §Ã`ìkËÞ·:]¦ƒåQÎc±%öž‚hï}·WÙ„f©x již]c@¸z…!ij‡³Üº-oÓ¯Tm=òv4(£c×ßl™™;ü. í ‡+ý#€4M•eÙ78&ð…òI=Ut»*H‡h®‚&4¢R8ÇTç “ãj ŸØwnú:ÆfÌïw((ô õ¼vq€£z¦åfһŠn>ðð™ÿ4Är ¢ãˆ@Ö õFæF é37ŠÃKÐ;PÎÎ@¡k((.K¥Ð²HïS•2â‹à¯œr (&y»Š>I%Àõ¡|ŠyC« hmš*Ëå·ÀO 2©U,? ±|9‡çåeÚ•šæô6,µ~ à)GLîá5—íq<B»â¸ø2½‰êûHrÜüÞÿn‘ÞÌòý{Ws =ßs”=$çýÌí5³.£ N¹˜5tØdCüˆ4o=+P€ßþMAò•7®´[Œ:µ5䫿‰+öl.Ó¿‹øâüqLtƧNü^†» `-eÊ¡ÌI¦”Ê'H:K=ÕŒLû¶þÍiGªÔZCæè1ˆás®L”¢^ÐÐà-cAK2é=Ù•¶›À¯;Cˆ#-Sŧ–ãýŠld¸µRËrïwDí<@îmõ`9íÈæ»ç¹î/F®Ó¿èñéß·a˜¿9Vòs· ÈÝTéÇ±Ø›Õ Ã}%û{ò_m=-øLå+/ýOJ×,ãEÿµaôL4AòjcÀëY9ýy+Ü×t™ç£?2>z92.^û•ùò(–ÉÊá¢k¡Þ7móÙvܶ P£¸hΖJ6UÔÔô›/ÃjCºx2ÏöÜW›¡ô4‰\@T*N§ó‹d÷©}PL öáâ9Ó-"êq`éAzœi;Ëø‚z–ÉøÂµ¾áŸÝ Ÿ’(ü“ÂNœÚF¥¨Û5ÅKÄýa_‡®-ÊMeÿ@ósfÅëVú«rtBa‚â5Rd0°ÆÇÆ7qºž”IƒƒíØûzçß›p~Ÿ5&HðÖÇ|€kk#[ úi[ĵýáX«c6)º¡ò/ØŽ÷9U5³ ÝØCzþå=¿D¡V— ÍðB@©cí Ö1,5”°©Cà˜–4»{¡)*¿GVQ2ûœWeÖ¥¼2¢f³zá`­†Ò¹€}¶CèÍý©¨ëy´Ãè:Ü™¦‡przÑQ> stream xÚ­ZK“㶾ϯPnšÊ Œ7ÈTù°v¼©uùg§*ÛŠ¢F¬P¤–ÏŽ}ºÑå]{}˜"- Ñ¯á›ç ßü뎇ï7Ow_½uf“²ÔJ»y:l·L³±)g©’›§ýæ§mÞì‹ûGiÌ6«÷ذ۾¡¼9‡¾ Ál¿/û²©³*N÷¿<}[$ó-´`Ö$À€_üg.l š3’0©ÒH“—EÝwìþQI»}:–­O_»=7]WîªÀãKÙ›¡,Õ÷Âl_i¦:j5šì·4Ú—§âyÙ< ²$uÐ,yx6JV ‚oû£ßŒ¢lå»0Ð]Ÿµ}±§î¡mNÔ\e]O­xÈPtÌobP°·dN:Úû p®\²Ý—]>t®ŠÝ²¦oWäøsê(&îuäÓÏŸ‹ø<;~s ×|û+ $ ’ísQçÅ’h¾@޷Éz(cjÁ)q&P7Ó¯¼ãAfB¬‡ÓÎ ®°¥–LF\˜…èü@FŸcù|œk¯€ÙG©ø¶`ÏáL‚?pÎÃð˱¬ß˹äŽ]2ÎתÁ>F¥ï ²¢‹Âƒƒét)¼cƒ[¿ kb{šzdÔYÞ{WT2Ꞧo Øjþ¸ŸÑšä/Ð@ñÂÓÛï–.“£ Ã¯Ñ Ó…š„i%f¬èVSv-FÀ•…,³I:[Ǭ®cÒÑ”ÇÇàüBNnJà/™ÑrƞМH1f÷ç¶É‹Žà)šb륬*lù „ñ Œgôù™s¹îB¶FMœÛâP~dçªYQz. ·}w 1´â^ýÈ2¨ ±l†nMO2á,¹ÔS?´;/Ù»ïžî>Ü¡­ñØ¥˜€½M´©Üä§»Ÿ~á›=L~¿áL¥ÉæÅ“ž6HˆPSmÞßýH)ÛRG | q —r``~ÛŠ"*[S–áLÈÑè!ŽæE$t&»})è{ÌîeLhÄã6†óš­¨s;Ú] þøµxjÉI0±ã1k¸6ö™ê´T’ÑÉ‚[/}V†ÓÁ—N*–$ëaÂyûj}r&1Qª†S½ÂšÕ+Q ?–+zNã€0Æp”û"=CJ.À´øJ’ÈÊ–©eüí/Ù2õÈs½å´éTOðgøZêÀ”…uþíc IS“a)ñ@‘¥¬I5£Ž åmüuD&ÓàˆûÔ…s¬Aå<êo«™$zfžÈÝ}0=9)Û°ÿ8wh†¶?R›ì&DV &Ÿ&I°7;³7eÜ"\IQúm\$À4/U8ä·ÂFyÊž!·k_‰â w š 'ÓêÛò·lWVeÿzo÷¸âæF¤¨2„!«/=Þy¨üï€Ü‚(Þ…¼S6ñ”|éNŸLå‡FUßJ°b¸©A²jÚ~‘5Cn¬ÀL6,éS@©Ô  t(ÝPº”î6PNÁÒã¤þ¤'xŒA§Ü]ÇOÅ“?=oˆ~Áðf^jf¼¶+6ƒ‡L°ç ‹!²¢î ‹òm2Âùo³LžƒpÞW±± &xqAÓ;Œ°Óâ•Ͻ}ÓW H•‚ªk>ÃA8©øÝ˜£á”ZA.kâ‹\F+Íj\Š‹à2g±²'ø”¾þŠ=á¦.·”k÷LδûäÐ/Ç¢-V“hÀ_­Ì@‰µe¤«×ùþe^lÇÌ:s‹UÈ&À-v«)NÊÜ”ŽßH™$àŸYÀvp;õžŒV'ç‹acæÇÑ/áeK¥"ïRŠr$]:ð­"‰4øïâår4ÇÝ*í ¹²Žµ éÚf?äP}l›Ïΰ·Íž‹9U”’·Y~kîÊ¿=|úúÖœìІ¢Îéö{U(ˆ.bòÌÏÈ*H"piàÎ,ó‚«Zb€_*¬/«ˆ!Øœ {7 ¬ˆ9=–²ê ìSöæ¯tcÝ\Jp%\z^:þ‡;_<’ÌÛ~2þ2 |õîd6ÿl ~§㪳ec±Ú±Ôq1/VË $ë9}[>­G×t«ÿqÿ¨ÁM¾½YêŒ÷;HM—³’§)™  S‡_;Š’ ç•ëp &mHšíT‹™øOàÌfFÌ–ʪ"”U'NÓ±†:çk¬¡zÖûâÜÑ|,‡S2Væ¤Á¬¶· “Œ’º7hh.{ÌuÍ¡§î¹+†}sn ö¥¯ôÃà˽àÞs%$‰¡¢amH‹±AŸÿ©öeþˆWz¯…WχX}°™äƒ93Oçåµ"EËR>ÒøŠ2¬¨8}ÿóJ<ùŠôé°ç‘1ò¢ñ˜†ÚÃdǦ4 /ê^rzVÌP¾nq‚ô»ì¢åìŠþ¥(ê ­‘=eÔÉzú‚£ò0BIB ¼ÓP²(…ûB)®‹+_¯rùHTFwÈ¢m:ëlW½Rÿ¹iö1}ŸÙÅí÷ºFø¥šA¹sÕb¿Íêg|5Ñ.¥7 L˜ËçcóãjvÛ²†z™òÚmë×û¸xý™‹aç~ÌÝê±BÈ9ã{ÐLzJ.¸ìâÓO°Xx=,^t Õû QÔÍàËÁÖÛ0ÖÌò| bWxAç[BïJ‡©Á£¾:î !£–fŠxcÁï¾ìÎU†®á¢ 8s[á8éË™‰z’ê|z‚CpK‡%Lú9K8•}•à j3#ó⨟蔫,Ùéi‰&Éo!ãH“‹¼ozoJíLSŒ¢…wk™b–Ÿk|h"Â}Ñge~å7OÇ7ˆÔ,ï‡8E*‡Æóì]qhÞœ}÷’±TlßÞ"©·¸ÃÊí:ÔÞOg|*Àd0€€¾À ˜A@“ljwz?pÛÏ5Õ:<£nðs¿äÌÿ€Àû9z¬ñùbþ{rFˆN¼v yT0:¨‰õ‰®¼°XžxéÓ2 Ìaì SxŽo½“Ò‰2®íÆctáiñøÄLr’¿÷Ï"±êñ vðF4½*êí¿ÿKßÕÌ ¹˜gfs6,ä®Éjf¶`cV窪¡ëÛðD[–o¼ó‡âsL »T½ÍÍï ÿh–ãÊ endstream endobj 77 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (./figure2_new.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 82 0 R /BBox [0 0 694 492] /Resources << /XObject << /Im0 83 0 R >>/ProcSet [ /PDF /Text /ImageC ] >> /Length 31 >> stream q 694 0 0 492 0 0 cm /Im0 Do Q endstream endobj 83 0 obj << /Type /XObject /Subtype /Image /Name /Im0 /Filter [/RunLengthDecode] /Width 694 /Height 492 /ColorSpace 84 0 R /BitsPerComponent 8 /SMask 85 0 R /Length 86 0 R >> stream ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿ‚‚‚‚‚‚‚‚‚‚‚‚‚‚‚ã‚ÿíÿ‚‚‚‚‚‚‚‚‚‚‚‚‚‚‚ã‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿòÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿòÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿòÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿòÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿòÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿòÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿòÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿòÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿòÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿòÿû‚ÿíÿøãÿ‚‚‚‚‚”‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿþÿû‚ÿíÿøãÿ‚‚‚‚‚”‚ÿ‚ÿâÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ§ÿû‚ÿíÿøãÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ ÿû‚ÿ‚ÿâÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ§ÿû‚ÿíÿøãÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿgHgHûÿû‚ÿ‚ÿâÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ§ÿû‚ÿíÿøãÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿgHgHûÿû‚ÿ‚ÿâÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ§ÿû‚ÿíÿøãÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿgHgHûÿû‚ÿ‚ÿßÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ§ÿû‚ÿíÿøãÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ ÿû‚ÿ‚ÿßÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ§ÿû‚ÿíÿøãÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ ÿû‚ÿ‚ÿßÿgHgH‚ÿ‚ÿ‚ÿõÿþìÿûãÿø×ÿþ‚ÿçÿþ‚ÿÃÿû‚ÿíÿøãÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ ÿû‚ÿ‚ÿßÿgHgH‚ÿ‚ÿˆÿïïÿûûÿûïÿûøÿûàÿø‚ÿêÿû‚ÿÆÿû‚ÿíÿøãÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ ÿû‚ÿ‚ÿßÿgHgH‚ÿ‚ÿˆÿïòÿûõÿûòÿþòÿûàÿû‚ÿêÿû‚ÿÆÿû‚ÿíÿøãÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ ÿû‚ÿ‚ÿâÿ gHgHgHgH‚ÿ‚ÿŽÿþàÿûòÿûøÿûòÿû‚ÿ‚ÿ‚ÿû‚ÿíÿøãÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ ÿû‚ÿ‚ÿâÿ gHgHgHgH‚ÿ‚ÿŽÿþãÿûïÿûøÿûïÿûÎÿþ’ÿþ‚ÿ®ÿû‚ÿíÿøãÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿgHgHgHûÿû‚ÿ‚ÿßÿgHgH‚ÿ‚ÿŽÿõéÿûïÿûûÿøïÿûÑÿû•ÿû‚ÿ®ÿû‚ÿíÿøãÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿgHgHgHûÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿåÿïïÿûïÿûûÿûìÿûãÿûøÿïõÿõïÿþûÿøøÿòõÿïõÿþïÿòïÿûûÿøïÿõ­ÿû‚ÿíÿøãÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿgHgHøÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿßÿòõÿøïÿøþÿûìÿûéÿõõÿûòÿûøÿøþÿõþÿõûÿûøÿûõÿûòÿøòÿþõÿøõÿûþÿþþÿøõÿûøÿþ°ÿû‚ÿíÿøãÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿgHgHøÿû‚ÿ‚ÿ‚ÿ’ÿgHgHìÿ gHgHgHgHgHgHgHgHgHgHgHìÿgHgHgHïÿgHgHgH¿ÿõøÿøïÿøþÿûìÿûãÿûõÿûòÿþòÿûøÿøïÿûøÿûõÿûïÿûõÿûòÿûõÿøõÿûøÿþ¡ÿû‚ÿíÿøãÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿgHgHøÿû‚ÿ‚ÿ‚ÿ’ÿgHgHìÿ gHgHgHgHgHgHgHgHgHgHgHìÿgHgHgHïÿgHgHgH¹ÿûøÿøïÿøþÿûìÿûãÿûõÿûõÿûòÿûøÿûìÿþõÿûõÿûïÿûøÿûìÿûøÿûòÿûøÿû¤ÿû‚ÿíÿøãÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿgHgHøÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÐÿûûÿøïÿøþÿûìÿûãÿûõÿûõÿûãÿûàÿøõÿûïÿûøÿûìÿûøÿûòÿûøÿõªÿû‚ÿíÿøãÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿgHgHøÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÐÿûûÿøïÿøþÿûìÿûãÿûõÿûõÿûãÿûãÿþþÿûõÿûïÿûøÿûìÿûøÿûòÿûõÿõ­ÿû‚ÿíÿøãÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿgHgHøÿû‚ÿ‚ÿåÿgHgHgHgHgH‚ÿ‚ÿ‚ÿûÿûøÿûïÿûûÿûìÿûãÿûõÿûõÿûãÿûéÿþøÿûõÿûïÿûøÿûìÿûøÿûòÿûòÿõ°ÿû‚ÿíÿøãÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿgHgHøÿû‚ÿ‚ÿåÿgHgHgHgHgH‚ÿ‚ÿ‚ÿûÿþõÿûïÿûøÿûïÿûãÿûõÿûõÿûãÿûìÿþõÿûõÿûïÿûøÿøïÿûøÿûòÿûìÿø³ÿû‚ÿíÿøãÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ²ÿgHgHgHøÿû‚ÿ‚ÿßÿgHgHgH‚ÿ‚ÿ‚ÿûÿþõÿøòÿûøÿûòÿûàÿûõÿûõÿøïÿþûÿûïÿûõÿûõÿûïÿûøÿøïÿþõÿûòÿûøÿþõÿû³ÿû‚ÿíÿøãÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ²ÿgHgHgHøÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÓÿûòÿûòÿþõÿûòÿûàÿûõÿûõÿøòÿþøÿûïÿûõÿûõÿûïÿûõÿûïÿþõÿûòÿûøÿþòÿþ³ÿû‚ÿíÿøãÿû‚ÿ‚ÿÍÿgHgH‚ÿ‚ÿ‚ÿìÿgHgHgHøÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿèÿøõÿþïÿûõÿûòÿûøÿûÝÿûòÿûõÿìõÿûïÿøûÿõøÿøþÿþøÿûòÿûõÿþòÿûòÿûøÿþõÿû³ÿû‚ÿíÿøãÿû‚ÿ‚ÿÍÿgHgHgH‚ÿ‚ÿ‚ÿÝÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿèÿïãÿõéÿòàÿïøÿøòÿõøÿìõÿøøÿøøÿøûÿïõÿòõÿïþÿòûÿï°ÿû‚ÿíÿøãÿû‚ÿ‚ÿÐÿgHgHgH‚ÿ‚ÿ‚ÿÚÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿþÿû‚ÿíÿøãÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ ÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿþÿû‚ÿíÿøãÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ ÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿþÿû‚ÿíÿøãÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ ÿû‚ÿ‚ÿåÿgHgHgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿªÿû‚ÿíÿøãÿû‚ÿ‚ÿÇÿgHgHgH‚ÿ‚ÿ‚ÿãÿû‚ÿ‚ÿåÿgHgHgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿªÿû‚ÿíÿøãÿû‚ÿ‚ÿÄÿgHgH‚ÿ‚ÿ‚ÿãÿû‚ÿ‚ÿåÿgHgHgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿªÿû‚ÿíÿøãÿû‚ÿ‚ÿÄÿgHgH‚ÿ‚ÿ‚ÿõÿgHgHõÿû‚ÿ‚ÿåÿgHgHgH‚ÿ‚ÿ‚ÿûÿþÔÿþïÿøãÿø×ÿþ‚ÿçÿþ‚ÿêÿû‚ÿíÿøãÿû‚ÿ‚ÿÓÿgHõÿgHgH‚ÿ‚ÿ‚ÿøÿgHgHgHõÿû‚ÿ‚ÿåÿgHgHgH‚ÿ‚ÿ‚ÿøæÿïòÿûøÿûïÿûøÿþÝÿø‚ÿíÿø‚ÿíÿû‚ÿíÿøãÿû‚ÿ‚ÿÓÿgHgHgHûÿgHgH‚ÿ‚ÿ‚ÿãÿû‚ÿ‚ÿåÿgHgHgH‚ÿ‚ÿˆÿþþÿøéÿìòÿþòÿûõÿûõÿûÝÿþ‚ÿçÿþ‚ÿêÿû‚ÿíÿøãÿû‚ÿ‚ÿÓÿgHgHgHûÿgHgHgH‚ÿ‚ÿ‚ÿæÿû‚ÿ‚ÿåÿgHgHgH‚ÿ‚ÿ‚ÿøìÿûãÿûòÿûõÿûòÿûËÿþ’ÿþ‚ÿÕÿû‚ÿíÿøãÿû‚ÿ‚ÿÄÿgHgHgH‚ÿ‚ÿ‚ÿæÿû‚ÿ‚ÿåÿgHgHgH‚ÿ‚ÿ‚ÿøìÿþàÿûïÿûûÿûïÿûÎÿû•ÿû‚ÿÕÿû‚ÿíÿøãÿû‚ÿ‚ÿÄÿgHgHgH‚ÿ‚ÿ‚ÿæÿû‚ÿ‚ÿåÿgHgHgH‚ÿ‚ÿ‚ÿøìÿøéÿøïÿûûÿûïÿøÑÿû•ÿû‚ÿÕÿû‚ÿíÿøãÿû‚ÿ‚ÿÄÿgHgHgH‚ÿ‚ÿ‚ÿæÿû‚ÿ‚ÿåÿgHgHgHgHgH‚ÿ‚ÿˆÿøïÿìòÿûìÿûûÿûïÿøæÿøûÿìøÿþûÿøõÿûûÿøûÿûûÿûøÿïõÿûòÿûûÿûòÿûûÿõïÿþûÿû×ÿû‚ÿíÿøãÿû‚ÿ‚ÿÁÿgHgH‚ÿ‚ÿ‚ÿæÿû‚ÿ‚ÿåÿgHgHgHgHgH‚ÿ¼ÿ.ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿëÿ.ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÂÿøæÿòõÿûìÿûþÿøïÿøìÿþþÿøõÿûòÿþõÿûõÿûøÿûþÿûõÿûõÿûøÿþþÿøõÿþòÿûòÿþþÿþøÿûõÿþõÿþ×ÿû‚ÿíÿøãÿû‚ÿ‚ÿÁÿgHgH‚ÿ‚ÿ‚ÿæÿû‚ÿ‚ÿâÿ gHgHgHgH‚ÿ¼ÿ.ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿëÿ.ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÂÿøÝÿøøÿûìÿûþÿøïÿøæÿøõÿûõÿþòÿøøÿøòÿûõÿûõÿûïÿûøÿûïÿûõÿûõÿûõÿþÈÿû‚ÿíÿøãÿû‚ÿ‚ÿÁÿgHgHgH‚ÿ‚ÿ‚ÿþÿgHgHgHõÿû‚ÿ‚ÿÜÿgHgH‚ÿ¼ÿ.ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿëÿ.ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÂÿøÝÿøøÿûìÿûþÿøïÿøæÿøõÿûõÿþòÿøøÿûïÿûõÿûõÿûïÿûøÿûïÿûõÿûõÿûõÿûËÿû‚ÿíÿøãÿû‚ÿ‚ÿÖÿgH‚ÿ‚ÿ‚ÿãÿgHgHgHõÿû‚ÿ‚ÿÜÿgHgH‚ÿ‚ÿˆÿøÚÿûøÿûìÿûþÿøïÿøæÿøõÿûõÿþàÿûàÿøõÿûïÿûøÿûìÿûøÿûõÿûõÿøÎÿû‚ÿíÿøãÿû‚ÿ‚ÿÖÿgHgHgH‚ÿ‚ÿ‚ÿÔÿû‚ÿ‚ÿÜÿgHgH‚ÿ‚ÿˆÿø×ÿþøÿûìÿûûÿûïÿøæÿøõÿûõÿþàÿûéÿûûÿûõÿûïÿûøÿûìÿûøÿûõÿûòÿõÔÿû‚ÿíÿøãÿû‚ÿ‚ÿÖÿgHgHgH‚ÿ‚ÿ‚ÿÔÿû‚ÿ‚ÿÜÿgHgH‚ÿ‚ÿˆÿø×ÿþøÿøïÿûûÿûïÿøæÿøõÿûõÿûãÿûìÿûøÿûõÿûïÿûøÿûìÿûøÿûõÿûìÿõÚÿû‚ÿíÿøãÿû‚ÿ‚ÿÖÿgHgHgH‚ÿ‚ÿ‚ÿÔÿû‚ÿ‚ÿÜÿgHgH‚ÿ‚ÿˆÿø×ÿþõÿûïÿûûÿûïÿûãÿøõÿûõÿûìÿþûÿûïÿûõÿûõÿûïÿûøÿûìÿþõÿûõÿûæÿûÚÿû‚ÿíÿøãÿû‚ÿ‚ÿÖÿgHgH‚ÿ‚ÿ‚ÿÑÿû‚ÿ‚ÿÜÿgHgH‚ÿ‚ÿˆÿøÚÿûõÿûòÿûõÿûòÿûãÿøõÿûõÿûãÿûïÿûõÿûõÿûïÿûøÿûïÿûõÿûõÿûõÿþõÿûÚÿû‚ÿíÿøãÿû‚ÿ‚ÿÖÿgHgH‚ÿ‚ÿ‚ÿÑÿû‚ÿ‚ÿåÿgHgHþÿgHgHŒÿgH‚ÿ‚ÿÿøïÿþïÿþòÿûòÿûõÿûõÿûàÿøõÿûõÿõøÿûøÿûïÿûõÿûõÿûïÿûõÿûòÿûõÿûõÿûõÿþòÿþÚÿû‚ÿíÿøãÿû‚ÿ‚ÿÙÿgHgHgHìÿgH‚ÿ‚ÿ‚ÿéÿû‚ÿ‚ÿåÿgHgHþÿgHgHŒÿgH‚ÿ‚ÿÿøòÿõøÿþìÿûøÿûïÿûøÿþÝÿøõÿòûÿìõÿøòÿòþÿõûÿõøÿøòÿûøÿûõÿøõÿøøÿûøÿûÚÿû‚ÿíÿøãÿû‚ÿ‚ÿÙÿgHgHgHïÿgHgH‚ÿ‚ÿ‚ÿéÿû‚ÿ‚ÿåÿgHgHþÿgHgHÿgHgH‚ÿ‚ÿâÿøÝÿøãÿøÂÿûïÿøÔÿûõÿþòÿû×ÿû¼ÿûÔÿû‚ÿíÿøãÿû‚ÿ‚ÿÙÿgHgHgHïÿgHgH‚ÿ‚ÿ‚ÿgHgHgHòÿû‚ÿ‚ÿ‚ÿãÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ£ÿû‚ÿíÿøãÿû‚ÿ‚ÿÙÿgHgHgH‚ÿ‚ÿ‚ÿéÿgHgHgHòÿû‚ÿ‚ÿ‚ÿæÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ£ÿû‚ÿíÿøãÿû‚ÿ‚ÿÙÿgHgHgH‚ÿ‚ÿ‚ÿéÿgHgHgHòÿû‚ÿ‚ÿ‚ÿãÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ£ÿû‚ÿíÿøãÿû‚ÿ‚ÿÙÿgHgHgH‚ÿ‚ÿ‚ÿéÿgHgHgHòÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿþÿû‚ÿíÿøãÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿgHgHgHòÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿþÿû‚ÿíÿøãÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿgHgHgHòÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿþÿû‚ÿíÿøãÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿgHgHgHòÿû‚ÿ‚ÿåÿgHgH‚ÿ‚ÿ‚ÿõæÿïïÿòéÿõÚÿû‚ÿçÿþ‚ÿêÿû‚ÿíÿøãÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿgHgHgHòÿû‚ÿ‚ÿåÿgHgHþÿgHgHgH‚ÿ‚ÿ”ÿéìÿïòÿûøÿûïÿþõÿûàÿø‚ÿíÿø‚ÿíÿû‚ÿíÿøãÿû‚ÿ‚ÿ¾ÿgHgHgH‚ÿ‚ÿ…ÿgHgHïÿû‚ÿ‚ÿåÿgHgHþÿgHgHgH‚ÿ‚ÿ”ÿþòÿûïÿþãÿûòÿûõÿûòÿû‚ÿØÿþ‚ÿÕÿû‚ÿíÿøãÿû‚ÿ‚ÿ¾ÿgHgHgH‚ÿ‚ÿ…ÿgHgHïÿû‚ÿ‚ÿ‚ÿæÿ gHgHgHgH‚ÿÿþïÿøõÿûãÿûòÿûõÿûòÿûËÿþ’ÿþ‚ÿÕÿû‚ÿíÿøãÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ»ÿgHgHgHïÿû‚ÿ‚ÿ‚ÿæÿ gHgHgHgH‚ÿÿþìÿûõÿþàÿûïÿûûÿûïÿûÎÿû•ÿû‚ÿÕÿû‚ÿíÿøãÿû‚ÿ‚ÿÜÿgHgHgH‚ÿ‚ÿ‚ÿéÿgHgHgHïÿû‚ÿ‚ÿ‚ÿæÿ gHgHgHgH‚ÿ‚ÿ÷ÿûõÿõìÿøïÿûûÿûïÿøàÿþøÿøéÿûàÿþòÿøòÿøìÿþìÿøàÿûéÿûÑÿû‚ÿíÿøãÿû‚ÿ‚ÿÜÿgHgHgH‚ÿ‚ÿ‚ÿÎÿû‚ÿ‚ÿ‚ÿæÿgHgH‚ÿ‚ÿñÿþõÿìòÿûìÿûþÿøïÿøæÿøõÿûòÿþõÿûøÿøþÿõûÿûøÿþòÿûòÿøòÿþøÿøøÿøûÿòòÿþøÿþ×ÿû‚ÿíÿøãÿû‚ÿ‚ÿ‚ÿ¹ÿ gHgHgHgH‚ÿ‚ÿôÿû‚ÿ‚ÿ‚ÿéÿgHgHgH³ÿÿÿìÿ/ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿìÿÿÿìÿÿÿÅÿûéÿõõÿûìÿûþÿøïÿøæÿøõÿûòÿþõÿøøÿøûÿþûÿûõÿûõÿûïÿûõÿþïÿûõÿøøÿûõÿþÈÿû‚ÿíÿøãÿû‚ÿ‚ÿ‚ÿ¹ÿ gHgHgHgH‚ÿ‚ÿôÿû‚ÿ‚ÿ‚ÿéÿgHgHgH³ÿÿÿìÿ/ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿìÿÿÿìÿÿÿÅÿþàÿøøÿûìÿûþÿøïÿøæÿøõÿûõÿþòÿøøÿøòÿûõÿûõÿûïÿûøÿûïÿûõÿûõÿûõÿþÈÿû‚ÿíÿøãÿû‚ÿ‚ÿ‚ÿ¹ÿgHgHgHgHgH‚ÿ‚ÿ÷ÿû‚ÿ‚ÿèÿgHgHgHŒÿgHgHgH³ÿÿÿìÿ/ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿìÿÿÿìÿÿÿÈÿûÝÿûøÿûìÿûþÿøïÿøæÿøõÿûõÿæøÿûÝÿûõÿûïÿûøÿûïÿûõÿûõÿûõÿûËÿû‚ÿíÿøãÿû‚ÿ‚ÿ‚ÿ¼ÿgHgHgHgHgHgH‚ÿ‚ÿ÷ÿû‚ÿ‚ÿèÿgHgHgHþÿgHgHgH˜ÿgHgHgH‚ÿ‚ÿúÿûÚÿûøÿûìÿûþÿøïÿøæÿøõÿûõÿþàÿûãÿõõÿûïÿûøÿûìÿûøÿûõÿûòÿøÑÿû‚ÿíÿøãÿû‚ÿ‚ÿÇÿÿÿúÿgHgHŒÿgHgHgHþÿgHgH‚ÿ‚ÿ÷ÿû‚ÿ‚ÿèÿgHgHgHþÿgHgHgH˜ÿgHgHgH‚ÿ‚ÿúÿþÔÿþøÿûìÿûûÿûïÿøæÿøõÿûõÿþàÿûéÿþøÿûõÿûïÿûøÿûìÿûøÿûõÿûïÿõ×ÿû‚ÿíÿøãÿû‚ÿ‚ÿÇÿ ÿÿÿÿþÿgHgHŒÿgHgH‚ÿ‡ÿgHgHìÿû‚ÿ‚ÿèÿgHgHgHþÿgHgHgH˜ÿgHgHgH‚ÿ‚ÿýÿþÑÿþøÿøïÿûûÿûïÿøæÿøõÿûõÿûãÿûìÿûøÿûõÿûïÿûøÿûìÿûøÿûõÿûìÿõÚÿû‚ÿíÿøãÿû‚ÿ‚ÿÊÿ ÿÿÿÿýÿgHgHŒÿgHgH‚ÿ‡ÿgHgHìÿû‚ÿ‚ÿèÿgHgHgHŒÿgHgHgHgHgH‚ÿ‡ÿþÎÿþõÿûïÿûûÿûïÿûãÿøõÿûõÿûìÿþûÿûïÿûõÿûõÿûïÿûøÿûìÿþõÿûõÿûæÿûÚÿû‚ÿíÿøãÿû‚ÿ‚ÿÜÿgHgHõÿÿÿÿÿÿÿgHgHßÿÿ³ÿgHgH‚ÿ‡ÿgHgHìÿû‚ÿ‚ÿèÿgHgHgH‰ÿ gHgHgHgH‚ÿŠÿþìÿþæÿûõÿûòÿûõÿûòÿûãÿøõÿûõÿûïÿþøÿûïÿûõÿûõÿûïÿûøÿûïÿûõÿûõÿûõÿþòÿþÚÿû‚ÿíÿøãÿû‚ÿ‚ÿßÿgHgHgHøÿÿÿýÿÿÿÿgHgHßÿýÿÿ‚ÿ‚ÿšÿû‚ÿ‚ÿèÿgHgHgHƒÿgHgH‚ÿÿæûÿøõÿûïÿþòÿûõÿûõÿûàÿøõÿûõÿõûÿûõÿûïÿûøÿøõÿûûÿþøÿûõÿûòÿþòÿûõÿûõÿþòÿþÚÿû‚ÿíÿøãÿû‚ÿ‚ÿÍÿÿÿýÿÿÿÿgHgHgHãÿ ÿÿÿ‚ÿ‚ÿœÿû‚ÿ‚ÿèÿgHgHgHƒÿgHgH‚ÿÿãøÿøûÿþæÿûþÿøïÿøþÿûÝÿøõÿõøÿïõÿõòÿõûÿøøÿõøÿøòÿøþÿûòÿõûÿõøÿûøÿþ×ÿû‚ÿíÿøãÿû‚ÿ‚ÿÍÿÿÿüÿý ÿÿgHgHgHæÿ ÿÿÿÿ‚ÿ‚ÿœÿû‚ÿÒÿgH›ÿgHgHgHƒÿgHgH‚ÿ‚ÿåÿøÝÿøãÿøÂÿûïÿøÔÿûõÿþòÿû×ÿû¼ÿûÔÿû‚ÿíÿøãÿû‚ÿ‚ÿÏÿýÿÿÿûÿÿÿÿgHgHæÿÿÿÿÿÿ¬ÿgHgHgH‚ÿ‚ÿýÿû‚ÿÒÿgH›ÿgHgHgHƒÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¦ÿû‚ÿíÿøãÿû‚ÿ‚ÿÐÿÿÿ÷ÿÿÿÿgHgHéÿÿÿýÿÿÿ¬ÿgHgHgH‚ÿ‚ÿýÿû‚ÿÒÿgHgHžÿgHgHgHþÿgHgHgHÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¦ÿû‚ÿíÿøãÿû‚ÿ‚ÿÐÿÿÿ÷ÿÿÿÿgHgHéÿÿÿýÿÿÿ¬ÿgHgHgH‚ÿ‚ÿýÿû‚ÿÒÿgHgHžÿgHgHgHþÿgHgHgHÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¦ÿû‚ÿíÿøãÿû‚ÿ‚ÿÐÿÿÿöÿý ÿÿgHgHéÿÿÿýÿÿþÿÁÿgHgH‚ÿ„ÿgHgHéÿû‚ÿÕÿ gHgHgHgH•ÿgHgHgH˜ÿgHgHgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¦ÿû‚ÿíÿøãÿû‚ÿ‚ÿÐÿÿÿöÿýÿÿèÿÿÿ÷ÿÿÿÄÿgHgHgH‚ÿ‡ÿgHgHéÿû‚ÿÒÿgHgHgH•ÿgHgHgH˜ÿgHgHgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¦ÿû‚ÿíÿøãÿû‚ÿ‚ÿßÿgHgHøÿÿÿôÿÿÿèÿÿÿ÷ÿÿÿÄÿgHgHgH‚ÿŠÿgHgHgHéÿû‚ÿ‚ÿÜÿgHgHgH˜ÿgHgHgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¦ÿû‚ÿíÿøãÿû‚ÿ‚ÿßÿgHgHúÿýÿðÿýÿêÿýÿÿ÷ÿÿÿ‚ÿ‚ÿ¢ÿû‚ÿ‚ÿÜÿgHgHgH‚ÿ‚ÿŽÿõæÿõéÿòéÿõÚÿû‚ÿçÿþ‚ÿêÿû‚ÿíÿøãÿû‚ÿ‚ÿâÿgHgHgHûÿÿÿîÿÿÿíÿýÿÿ÷ÿÿþÿ‚ÿ‚ÿ¢ÿû‚ÿ‚ÿÜÿgHgHgH‚ÿ‚ÿ”ÿûûÿøïÿûõÿûòÿûøÿûïÿþõÿûàÿø‚ÿíÿø‚ÿíÿû‚ÿíÿøãÿû‚ÿ‚ÿâÿgHgHgHûÿÿÿîÿÿÿîÿÿÿóÿýÿÿ‚ÿ‚ÿ¥ÿû‚ÿ‚ÿÜÿgHgHgH‚ÿ‚ÿ”ÿþõÿøòÿûõÿûòÿþòÿûõÿûõÿûÝÿþ‚ÿçÿþ‚ÿêÿû‚ÿíÿøãÿû‚ÿ‚ÿâÿgHgHgHûÿÿÿîÿÿÿîÿÿÿñÿÿÿ¯ÿgHgHgH‚ÿ‚ÿÿû‚ÿ‚ÿÙÿgHgH‚ÿ‚ÿ—ÿþïÿûõÿøòÿûøÿûòÿûõÿûòÿûËÿþ’ÿþ‚ÿÕÿû‚ÿíÿøãÿû‚ÿ‚ÿâÿgHgHgHûÿÿêÿýÿÿóÿýÿîÿÿÿ¯ÿgHgHgH‚ÿ†ÿÿù‚ÿÕÿgHgH›ÿgHgHgHûÿgHgH‚ÿ‚ÿ‚ÿûõÿûïÿûøÿûïÿûûÿûïÿûÎÿû•ÿû‚ÿÕÿû‚ÿíÿøãÿû‚ÿ‚ÿâÿgHgHgHûÿÿèÿÿÿôÿÿÿíÿýÿ¯ÿgHgHgH‚ÿ†ÿÿù‚ÿÕÿ gHgHgHgH¡ÿgHgHgHûÿgHgH‚ÿ‚ÿ‚ÿþòÿûïÿûûÿøïÿûûÿûïÿøàÿþøÿøéÿûàÿþòÿøòÿøìÿþìÿøàÿûéÿûÑÿû‚ÿíÿøãÿû‚ÿ‚ÿâÿgHgHøÿÿèÿÿÿöÿýÿÿëÿÿÊÿgHgH‚ÿ„ÿgHgHëÿÿù‚ÿÕÿ gHgHgHgH’ÿgHgH˜ÿgHgHgH‚ÿ‚ÿ÷ÿûòÿûïÿûûÿûìÿûûÿûïÿøæÿøûÿìøÿþûÿøõÿûûÿøûÿûûÿûøÿïõÿûòÿûûÿûòÿûûÿõïÿþûÿû×ÿû‚ÿíÿøãÿû‚ÿ‚ÿâÿgHgHûÿÿÿèÿÿþÿÿúÿ ÿÿÿëÿÿÊÿgHgHgH‚ÿ‡ÿgHgHëÿÿù‚ÿÕÿ gHgHgHgH‚ÿ¢ÿgHgHgHgHgH¹ÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÊÿûòÿøïÿøþÿûìÿûþÿøïÿøìÿþþÿøõÿûòÿþõÿûõÿûøÿûþÿûõÿûõÿûøÿþþÿøõÿþòÿûòÿþþÿþøÿûõÿþõÿþ×ÿû‚ÿíÿøãÿû‚ÿ‚ÿâÿgHgHûÿÿÿåÿÿÿúÿÿÿèÿÿÿÍÿgHgH‚ÿ‡ÿgHgHgHëÿþÿú‚ÿÕÿgHgH‚ÿœÿgHgHgHgHgH¹ÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÐÿïøÿøïÿøþÿûìÿûþÿøïÿøæÿøõÿûõÿþòÿøøÿøòÿûõÿûõÿûïÿûøÿûïÿûõÿûõÿûõÿþÈÿû‚ÿíÿøãÿû‚ÿ‚ÿâÿgHgHûÿÿÿåÿ ÿÿÿÿÿýÿÿèÿÿÿ‚ÿ‚ÿÌÿgHgHgHîÿÿþÿú‚ÿÕÿgHgH‚ÿ‚ÿÄÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÇÿøøÿøïÿøþÿûìÿûþÿøïÿøæÿøõÿûõÿæøÿûÝÿûõÿûïÿûøÿûïÿûõÿûõÿûõÿûËÿû‚ÿíÿøãÿû‚ÿ‚ÿßÿgHûÿÿÿâÿÿÿÿÿÿåÿÿÿ‚ÿ‚ÿÌÿgHgHgHîÿþÿÿú‚ÿÕÿgHgH‚ÿ‚ÿ‚ÿ†ÿøûÿøïÿøþÿûìÿûþÿøïÿøæÿøõÿûõÿþàÿûãÿõõÿûïÿûøÿûìÿûøÿûõÿûòÿøÑÿû‚ÿíÿøãÿû‚ÿ‚ÿÖÿÿßÿÿþ ÿÿÿÿâÿÿ‚ÿ‚ÿÌÿgHgHgHîÿþÿÿú‚ÿÕÿgHgH‚ÿ‚ÿ‚ÿƒÿûøÿûïÿûûÿûìÿûûÿûïÿøæÿøõÿûõÿþàÿûéÿûûÿûõÿûïÿûøÿûìÿûøÿûõÿûòÿõÔÿû‚ÿíÿøãÿû‚ÿ‚ÿÙÿÿÿÜÿÿþÿÿßÿÿÿ¯ÿgHgH‚ÿ¨ÿgHgHgHîÿþÿÿú‚ÿÕÿgHgH‚ÿ‚ÿ‚ÿƒÿûøÿûïÿûûÿøïÿûûÿûïÿøæÿøõÿûõÿûãÿûìÿûøÿûõÿûïÿûøÿûìÿûøÿûõÿûìÿõÚÿû‚ÿíÿøãÿû‚ÿ‚ÿÙÿÿÿ¯ÿÿÿ¯ÿgHgH‚ÿ¨ÿgHgHgHîÿÿÿù‚ÿÕÿgHgH›ÿgHgHøÿgHgH‚ÿ‚ÿ‚ÿþÿþõÿûïÿûøÿûïÿûûÿûïÿûãÿøõÿûõÿûìÿþûÿûïÿûõÿûõÿûïÿûøÿûìÿþõÿûõÿûæÿûÚÿû‚ÿíÿøãÿû‚ÿ‚ÿÙÿÿÿßÿgHgH×ÿÿÿ¯ÿgHgH‚ÿ¨ÿgHgHgHîÿÿýÿû‚ÿÕÿ gHgHgHgH¡ÿgHgHøÿgHgH‚ÿ‚ÿ‚ÿþÿþõÿøòÿþõÿûòÿûõÿûòÿûãÿøõÿûõÿûïÿþøÿûïÿûõÿûõÿûïÿûøÿûïÿûõÿûõÿûõÿþòÿþÚÿû‚ÿíÿøãÿû‚ÿ‚ÿÙÿÿÿßÿgHgHgHÚÿÿÿÓÿgHàÿgHgHgH‚ÿ«ÿgHgHîÿÿýÿÿû‚ÿÕÿ gHgHgHgH¡ÿgHgHøÿgHgH˜ÿgHgH‚ÿ‚ÿñÿûòÿûõÿûõÿûòÿûõÿûõÿûàÿøõÿûõÿõøÿûøÿûïÿûõÿûõÿûïÿûõÿûòÿûõÿûõÿûõÿþòÿþÚÿû‚ÿíÿøãÿû‚ÿ‚ÿÙÿÿÿßÿgHgH×ÿÿÿÖÿgHgHgHãÿgHgHgH‚ÿ®ÿgHgHgHîÿÿýÿÿû‚ÿÏÿgHgH‚ÿ¢ÿgHgHþÿgHgHgH‚ÿ“ÿøÝÿûûÿûïÿûøÿûïÿûøÿþÝÿøõÿòûÿìõÿøòÿòþÿõûÿõøÿøòÿûøÿûõÿøõÿøøÿûøÿûÚÿû‚ÿíÿøãÿû‚ÿ‚ÿèÿgHgHgHûÿÿÿ®ÿýÿÿÙÿgHgHgHãÿgHgHgH‚ÿ®ÿgHgHgHîÿýÿÿÿû‚ÿÏÿgHgH‚ÿ¢ÿgHgHþÿgHgHgH‚ÿÿõÝÿûãÿøãÿøÂÿûïÿøÔÿûõÿþòÿû×ÿû¼ÿûÔÿû‚ÿíÿøãÿû‚ÿ‚ÿèÿgHgHgHýÿýÿ©ÿÿÿÙÿgHgHgHàÿgHgH‚ÿ’ÿýÿÿÿû‚ÿÏÿgHgH‚ÿ¢ÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿû‚ÿíÿøãÿû‚ÿ‚ÿâÿgHþÿÿÿ©ÿÿÿÙÿgHgHÝÿgHgH‚ÿ“ÿÿÿýÿû‚ÿÏÿgHgH‚ÿ¢ÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿû‚ÿíÿøãÿû‚ÿ‚ÿÜÿÿÿ©ÿÿÿÙÿgHgHÝÿgHgH‚ÿ–ÿ ÿÿÿýÿû‚ÿÏÿgHgH‚ÿ¢ÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿû‚ÿíÿøãÿû‚ÿ‚ÿÜÿÿÿ©ÿÿÿÙÿgHgHÝÿgHgH‚ÿ–ÿÿÿúÿû‚ÿÏÿgHgHgH‚ÿ¥ÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿû‚ÿíÿøãÿû‚ÿ‚ÿÜÿÿÿ¨ÿýÿÿÜÿgHgHÝÿgHgHgH‚ÿœÿÿÿ÷ÿû‚ÿÏÿgHgHgH¤ÿgHgHøÿgHgHgH›ÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿû‚ÿíÿøãÿû‚ÿ‚ÿÜÿÿÿÙÿgHgHgH×ÿÿÿßÿgHgHgHÝÿgHgHgH‚ÿŸÿÿÿôÿû‚ÿØÿgHgHgHgHgHgH¤ÿgHgHøÿgHgHgH›ÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿû‚ÿíÿøãÿû‚ÿ‚ÿÜÿÿÿÙÿgHgHgH×ÿÿÿßÿgHgHgH‚ÿ°ÿñÿìÿgHgHòÿÿÿôÿû‚ÿØÿgHgHgHgHgHgH¤ÿgHgHøÿgHgHgH›ÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿû‚ÿíÿøãÿû‚ÿ‚ÿßÿÿÿÓÿgHgHÖÿýÿßÿgHgHgH‚ÿ³ÿÿÿ÷ÿÿìÿgHgHgHøÿÿÿñÿû‚ÿÏÿgHgHgH¤ÿgHgH‰ÿgHgHþÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ©ÿû‚ÿíÿøãÿû‚ÿ‚ÿëÿgHgHgHþÿÿÿÓÿgHgHÖÿýÿßÿgHgH‚ÿ°ÿÿÿ÷ÿÿÿïÿgHgHõÿÿÿñÿû‚ÿ‚ÿèÿgHgH‰ÿgHgHþÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ©ÿû‚ÿíÿøãÿû‚ÿ‚ÿëÿgHgHgHþÿÿÿÓÿgHgHÔÿÿÿ‚ÿ‹ÿÿÿ÷ÿÿÿàÿÿÿÿÿÿÿøÿû‚ÿ‚ÿèÿgHgH‚ÿ ÿÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ©ÿû‚ÿíÿøãÿû‚ÿ‚ÿèÿgHgHþÿÿÐÿgHgHgH×ÿÿÿ‚ÿŽÿÿÿñÿÿàÿÿÿÿÿÿõÿû‚ÿ‚ÿèÿgHgH‚ÿ ÿÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ©ÿû‚ÿíÿøãÿû‚ÿ‚ÿßÿÿÐÿgHgHgH×ÿÿÿ‚ÿŽÿÿÿñÿÿÿãÿÿÿÿÿÿõÿû‚ÿ‚ÿèÿgHgH‚ÿ ÿÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ©ÿû‚ÿíÿøãÿû‚ÿ‚ÿßÿÿÐÿgHgHgHÔÿÿÿÿ³ÿgHgH‚ÿíÿÿÿÿÿÿñÿÿÿæÿÿÿÿÿÿÿõÿû‚ÿ‚ÿèÿgHgH‚ÿ ÿÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ©ÿû‚ÿíÿøãÿû‚ÿ‚ÿâÿÿÿÍÿgHgHgH×ÿÿÿ²ÿgHgH‚ÿðÿÿÿÿÿÿÿîÿÿÿìÿÿÿÿÿÿÿÿõÿûÎÿgHgHgH‚ÿ¥ÿgHgHøÿgHgHgH’ÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ©ÿû‚ÿíÿøãÿû‚ÿ‚ÿâÿÿÿÍÿgHgHgH×ÿ ÿÿÿÿ¶ÿgHgHgH‚ÿóÿÿþ ÿÿÿÿúÿÿÿÿÿÿÿÿþÿÿÿÿÿÿÿþÿÿÿÿÿÿòÿûÎÿ gHgHgHgH˜ÿgHgHgH›ÿgHgHøÿgHgHgH’ÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ©ÿû‚ÿíÿøãÿû‚ÿ‚ÿâÿÿÿÍÿgHgHgHÔÿÿÿîÿgHgH‚ÿºÿÿþ;ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿÿÿÿòÿûÎÿ gHgHgHgH˜ÿgHgHgHgHgHgH¤ÿgHgHøÿgHgHgH’ÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ©ÿû‚ÿíÿøãÿû‚ÿ‚ÿâÿÿÊÿgHgHÑÿÿÿîÿgHgHgH‚ÿ½ÿ@ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿÿÿÿòÿûÎÿ gHgHgHgHÿgHgHgH•ÿgHgHgHžÿgHgHgHþÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ©ÿû‚ÿíÿøãÿû‚ÿ‚ÿîÿgHgHûÿÿ”ÿ ÿÿÿÿòÿgHgHgH‚ÿÀÿÿÿÿÿÿÿøÿÿÿÿøÿÿÿÿÿÿgHÿÿÿüÿ ÿÿÿòÿûÎÿgHgHgH‚ÿ–ÿgHgHgHžÿgHgHgHþÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ©ÿû‚ÿíÿøãÿû‚ÿ‚ÿîÿgHgHþÿÿÿ“ÿýÿÿ‚ÿªÿÿÿÿÿÿÿÿõÿÿÿôÿýÿÿÿÿÿÿùÿÿÿïÿûÎÿgHgHgH‚ÿ–ÿgHgHgHÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ©ÿû‚ÿíÿøãÿû‚ÿ‚ÿñÿgHgHgHþÿÿÿ‘ÿ ÿÿÿÿ‚ÿ®ÿÿÿüÿÿßÿÿý ÿÿÿÿöÿÿìÿûÎÿgHgHgH‚ÿ–ÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ°ÿû‚ÿíÿøãÿû‚ÿ‚ÿñÿgHgHgHþÿÿÿ‘ÿ ÿÿÿðÿÿ‚ÿÆÿ ÿÿÿÿýÿÿÜÿÿÿñÿÿÿìÿûÎÿgHgHgH‚ÿ–ÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ°ÿû‚ÿíÿøãÿû‚ÿ‚ÿñÿgHgHgHÿÿÿý ÿÿÿÿ÷ÿÿÿËÿgHgH†ÿ ÿÿÿüÿÿÿÜÿÿñÿ ÿÿÿìÿûÎÿgHgHgH‚ÿ–ÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ°ÿû‚ÿíÿøãÿû‚ÿ‚ÿôÿgHgHgHþÿÿÿ»ÿgHÓÿýÿÿÿÿÿÿÿÿýÿÿÿÿÿÙÿgHgH‰ÿ ÿÿÿºÿ ÿÿÿéÿûÎÿgHgHgH‚ÿ¥ÿgHgHøÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ°ÿû‚ÿíÿøãÿû‚ÿ‚ÿôÿgHgHgHþÿÿÿ¾ÿgHgHÐÿý ÿÿÿÿÿýÿÿÿÿÿÿÿÿÜÿgHgH ÿÿòÿÿÿÿÿÿ¸ÿÿæÿûÎÿ gHgHgHgH˜ÿgHgH˜ÿgHgHøÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ°ÿû‚ÿíÿøãÿû‚ÿ‚ÿôÿgHgHgHþÿÿÿ¾ÿgHgHÎÿ(ÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿôÿÿÿøÿÿÿÿÿÿËÿgHgHñÿÿæÿûÎÿ gHgHgHgH˜ÿgHgHþÿgHgHgH¤ÿgHgHøÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ°ÿû‚ÿíÿøãÿû‚ÿ‚ÿôÿgHgHgHÿÿ»ÿgHÈÿÿÿÿÿÿÿôÿÿÿ‚ÿ÷ÿÿÿÿýÿÿÿÿÿÿÈÿgHgHÑÿûÈÿgHgH˜ÿgHgHþÿgHgHgH‚ÿ¨ÿgHgHgHûÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ©ÿû‚ÿíÿøãÿû‚ÿ¥ÿÿÿÿÚÿgHgHþÿÿÿ‚ÿøÿgHgHëÿýÿÿ‚ÿ÷ÿÿýÿÿÿÿÿÿÈÿgHgHgHÑÿû‚ÿØÿgHgHþÿgHgHgH‚ÿ¨ÿgHgHgHûÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ©ÿû‚ÿíÿøãÿû‚ÿ«ÿÿÿÿÿÿßÿgHgHgHþÿÿÿ‚ÿÚÿ ÿÿÿ‚ÿøÿ ÿÿÿðÿÑÿgHgHgHÑÿû‚ÿØÿgHgH‚ÿÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ©ÿû‚ÿíÿøãÿû‚ÿ®ÿÿÿÿÿÿÿÿßÿ gHgHÿÿ‚ÿÖÿýÿÿÿïÿÿÿÿÿÿÿ÷ÿÿÿ×ÿgHgHgHÎÿû‚ÿØÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ®ÿû‚ÿíÿøãÿû‚ÿ®ÿÿÿúÿÿÿÙÿÿÿ‚ÿÔÿ ÿÿÿ“ÿÿÿøÿÿÿÿÿÿÿÿÿýÿ ÿÿÿ×ÿgHgHgHÎÿû‚ÿØÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ®ÿû‚ÿíÿøãÿû‚ÿ®ÿÿÿ÷ÿÿÿßÿÿÿ‚ÿÐÿýÿÿÿåÿgHgHgH»ÿÿÿûÿÿþÿÿüÿÿÿÿÿÿÿÿÔÿgHgHgHÎÿû‚ÿØÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ®ÿû‚ÿíÿøãÿû‚ÿ±ÿÿÿñÿÿÿâÿÿÿ¬ÿgHgHgH¬ÿýÿÿÿèÿgHgHgH¾ÿÿÿøÿÿÿóÿ ÿÿÿÿÔÿgHgHgHËÿû‚ÿØÿgHgH›ÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿžÿû‚ÿíÿøãÿû‚ÿ±ÿÿîÿÿÿåÿÿÿ¦ÿgHgHÝÿgHgHÖÿÿý ÿÿÿÿêÿ ÿÿÿÄÿÿÿûÿ ÿÿÿ¸ÿgHgHgHËÿûÎÿgHgH’ÿgHgH›ÿgHgHgHøÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ°ÿû‚ÿíÿøãÿû‚ÿ´ÿÿÿëÿÿÿèÿÿÿ¦ÿgHgHÝÿgHgHgHÖÿþÿþ ÿÿÿÿ÷ÿÿÿÿÿÿÿÿÿÊÿÿÿûÿ ÿÿÿ¸ÿ gHgHgHgHËÿûÎÿgHgHgHgHgH›ÿgHgHþÿgHgHgH§ÿgHgHgHøÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ°ÿû‚ÿíÿøãÿû‚ÿ´ÿÿÿëÿ ÿÿÿôÿgHþÿ ÿÿÿÿ‚ÿ ÿÿgHgHgHÐÿþÿþ-ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ×ÿÿÿÿÿÿÿþÿ ÿÿÿµÿgHgHgHÈÿûÈÿgHgHgH›ÿgHgHþÿgHgHgH‚ÿ¨ÿgHgHgHûÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿû‚ÿíÿøãÿû‚ÿ´ÿÿåÿ ÿÿÿ÷ÿ gHÿÿÿ‚ÿþÿgHgHgHÊÿÿþÿþ*ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿæÿÿþ#ÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿïÿûÈÿgHgHgH’ÿgHgHgH‚ÿ¨ÿgHgHgHûÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿû‚ÿíÿøãÿû‚ÿ·ÿÿÿâÿÿÿÿÿÿÿÿÿÿ‹ÿgHþÿgHgHgHgHgHgHÇÿÿÿûÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿìÿÿþ#ÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿìÿûÈÿgHgHgH’ÿgHgHgH‚ÿ¨ÿgHgHgHûÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿû‚ÿíÿøãÿû‚ÿºÿ ÿÿÿÿàÿÿÿÿÿÿÿÿ‹ÿgHgHgHgHgHgHgH¾ÿÿæÿÿÿÿÿÿÿÿõÿÿÿþÿÿÿùÿþ ÿÿÿÿ‚ÿäÿûÈÿgHgHgH’ÿgHgHgH‚ÿ¨ÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿû‚ÿíÿøãÿû‚ÿºÿÿÿÙÿÿÿÿÿÿˆÿgHgHgHgHgHgH˜ÿÿÿÿÿÿÿÿûÿÿþ ÿÿÿÿùÿ ÿÿÿ‚ÿÞÿûÈÿgHgHgHÿgHgH‚ÿ¨ÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿû‚ÿíÿøãÿû‚ÿáÿgHgHàÿÿÿ‚ÿ‚ÿÒÿÿþÿÿÿÿÿÿÿýÿÿÿÿÿùÿ ÿÿÿ‚ÿÛÿûÈÿgHgHgHÿgHgH‚ÿ¨ÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿû‚ÿíÿøãÿû‚ÿäÿ gHgHgHgHæÿÿÿ‚ÿ‚ÿÌÿÿÿþÿÿÿÿÿÿÿÿöÿ ÿÿÿ§ÿgHgH¹ÿûÈÿgHgHgHÿgHgH§ÿgHgHgHŒÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿû‚ÿíÿøãÿû‚ÿáÿgHgHãÿÿÿ‚ÿ‚ÿÀÿ ÿÿÿÿóÿ ÿÿÿ§ÿ gHgHgHgH¼ÿûÑÿgHgHgHgHgHgH›ÿgHgHûÿgHgH§ÿgHgHgHøÿgHgHgHžÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿû‚ÿíÿøãÿû‚ÿÀÿ ÿÿÿÖÿgH‚ÿ‚ÿçÿîÿÿÿ¡ÿgHgH¹ÿûÑÿgHgHgHgHgHgH›ÿgHgHûÿgHgH§ÿgHgHgHøÿgHgHgHžÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿû‚ÿíÿøãÿû‚ÿöÿgHgHgHÔÿÿÿÖÿgHgHgH‚ÿ‚ÿ‚ÿžÿûÎÿgHgHgHgHgH›ÿgHgHûÿgHgH§ÿgHgHgHøÿgHgHgHžÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿû‚ÿíÿøãÿû‚ÿùÿgHgHgHÔÿÿÿÓÿgHgHgH‚ÿ‚ÿ‚ÿžÿûÈÿgH‰ÿgHgH§ÿgHgHgHŒÿgHgHgHûÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿû‚ÿíÿøãÿû‚ÿüÿ gHgHgHgH×ÿ ÿÿÿÐÿgH‚ÿ‚ÿèÿgHgHgH‚ÿ½ÿû‚ÿ‚ÿëÿgHgHgH‰ÿgHgHûÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿû‚ÿíÿøãÿû‚ÿüÿgHgHgHàÿgHgHþÿ ÿÿÿ‚ÿ‚ÿ±ÿgHgH¡ÿgHgHgH¤ÿû‚ÿ‚ÿëÿgHgHgH‚ÿüÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿû‚ÿíÿøãÿû‚ÿüÿgHgHgHãÿgHgHgHgHÿÿ‚ÿ‚ÿ®ÿgHgH¡ÿ gHgHgHgH§ÿû‚ÿ‚ÿëÿgHgHgH‚ÿüÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿû‚ÿíÿøãÿû‚ÿÿÿÿÿÿÿÿåÿgHgHÿÿÿÜÿgH‚ÿ‚ÿ¾ÿgH³ÿgH¡ÿû‚ÿ‚ÿëÿgHgHgH‚ÿüÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿû‚ÿíÿøãÿûƒÿÿÿÿÿÿÿÿÿëÿ ÿÿÿÜÿgHgHgH‚ÿ‚ÿ¾ÿgHgHgHÚÿ gHgHgHgH‰ÿû‚ÿ‚ÿëÿgHgHgH‚ÿüÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿû¼ÿþ¶ÿøãÿû†ÿ ÿÿÿÿýÿ#ÿÿÿÿÿÿÿÿÿÿÿÿûòÿgHgHûÿgHgHgHgHgHgHgHgH‚ÿÿÿû‚ÿÌÿûgHìÿ#gHgHgHgHgHgHgHgHgHgHgHgHŒÿûÑÿgHgHgH•ÿgHgHgH›ÿgHgHgHõÿgHgHÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿû¼ÿû¹ÿøãÿû‰ÿ ÿÿÿñÿÿÿÿÿÿÿÿÿÿÿûòÿ gHgHgHgHgHgHgHgHgHgHgH‚ÿüÿû‚ÿÌÿûgHìÿ#gHgHgHgHgHgHgHgHgHgHgHgHŒÿûÑÿgHgHgHþÿgHgHžÿgHgHgHõÿgHªÿgHgHgHõÿgHgHÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿû¼ÿõ¿ÿøãÿûŒÿ ÿÿÿèÿÿÿÿÿÿÿýÿûòÿgHgHgHgHgHgHgHgH‚ÿóÿû‚ÿÌÿûéÿgHgHgH‚ÿðÿûÑÿgHgHgHþÿgHgHžÿgHgHgHûÿgHgHgH•ÿgHgHžÿgHgHøÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿû°ÿøÈÿøãÿûÿ ÿÿÿÍÿû‚ÿÌÿû‚ÿÌÿû‚ÿÏÿûÑÿgHgHgHþÿgHgHÿgHgHgH•ÿgHgHžÿgHgHøÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿû§ÿøÑÿøãÿû•ÿ ÿÿÿÿÊÿû‚ÿÌÿû‚ÿÌÿû‚ÿÏÿûÑÿgHgH‚ÿÿgHgHžÿgHgHøÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿûžÿøÚÿøãÿû˜ÿ ÿÿÿÄÿû‚ÿÌÿû‚ÿÌÿû‚ÿÏÿûÑÿgHgH‚ÿÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ°ÿûžÿòàÿøãÿûžÿ ÿÿÿÿÁÿû‚ÿÌÿû‚ÿÌÿû‚ÿÏÿûÑÿgHgH‚ÿÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ°ÿû§ÿïþÿøæÿøãÿû¤ÿÿÿÿÿÿ¾ÿû‚ÿÌÿû‚ÿÌÿû‚ÿÏÿûÑÿgHgH‚ÿÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ°ÿû­ÿïïÿûìÿøãÿû°ÿÿÿÿÿÿÿÿÿgHgH¿ÿû‚ÿÌÿû‚ÿÌÿû‚ÿÏÿûÑÿgHgH‚ÿÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ°ÿû¼ÿþþÿìæÿøòÿøãÿûÅÿ%ÿÿÿÿÿÿÿÿÿÿÿÿ²ÿû‚ÿÌÿû‚ÿÌÿû‚ÿÏÿûÑÿgHgH’ÿgHgHgH›ÿgHgHòÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ°ÿû¼ÿìÝÿûòÿøãÿû×ÿ1ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ¬ÿû‚ÿÌÿû‚ÿÌÿû‚ÿÏÿûÑÿgHgHûÿgHgHžÿgHgHgH›ÿgHgHòÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ°ÿû¼ÿòÚÿøòÿøãÿùQÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿgHgH¤ÿû‚ÿÌÿû‚ÿÌÿû‚ÿÏÿûÑÿgHgHûÿgHgHžÿgHgHgHûÿgHgHgH•ÿgHgHžÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿšÿû¼ÿøÔÿøòÿøãÿ‚‚‚‚‚”ÅÿgHgHžÿgHgHgHûÿgHgHgH‚ÿ«ÿgHgHøÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿû¼ÿþÎÿøòÿøãÿ‚‚‚‚‚”‚ÿÛÿgHgHgH‚ÿœÿgHgHøÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÏÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ®ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÏÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ®ÿû¼ÿþàÿþÚÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÏÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ®ÿû¼ÿþÝÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÏÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ®ÿû¼ÿþàÿøàÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÅÿgHgH’ÿgHgHgH›ÿgHgHòÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ³ÿûËÿÅàÿøæÿõ‚ÿÉÿþ‚ÿÉÿû‚ÿØÿõ‚ÿÛÿþìÿûàÿgHgHûÿgHgHžÿgHgHgH›ÿgHgHòÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ³ÿûÅÿÎÝÿøéÿþûÿø‚ÿÏÿû‚ÿÏÿþ‚ÿÒÿþõÿþ‚ÿäÿøïÿþøÿþæÿgHgHûÿgHgHžÿgHgHgHûÿgHgHgHªÿgHgHòÿgHgHgH¤ÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿšÿûÂÿÔÚÿøìÿþõÿû‚ÿÒÿþþÿþ‚ÿÕÿû‚ÿÏÿþõÿû‚ÿäÿûòÿûõÿþÝÿgHgHgH’ÿgHgHgH‚ÿ®ÿgHgHgHøÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿû¿ÿû¶ÿøÚÿþ‚ÿÌÿþ‚ÿØÿû‚ÿÌÿþõÿþ‚ÿáÿûòÿþòÿþÝÿgHgHgH’ÿgHgHgH‚ÿ®ÿgHgHgHøÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿû¼ÿþ¶ÿøÚÿþ‚ÿÕÿþûÿþ‚ÿØÿû‚ÿÌÿûûÿû‚ÿáÿûõÿûòÿþÝÿgHgHgHÿgHgH‚ÿ®ÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿšÿû‚ÿíÿøÝÿû‚ÿÌÿþ‚ÿØÿþûÿû‚ÿÒÿõ‚ÿÞÿûõÿûòÿûàÿgHgHgHÿgHgH‚ÿ®ÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿšÿû‚ÿíÿøÝÿþ‚ÿÕÿþøÿþ‚ÿÛÿûõÿþ‚ÿÒÿø‚ÿÞÿûõÿûòÿûàÿgHgHgHÿgHgH‚ÿ®ÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿšÿû•ÿþÝÿøàÿþ‚ÿÕÿþõÿþ‚ÿÛÿûõÿû‚ÿØÿþûÿû‚ÿáÿûõÿûòÿûàÿgHgHgHÿgHgH‚ÿ®ÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿšÿûÑÿûõÿÔÝÿøãÿþ‚ÿÕÿæ‚ÿáÿûòÿþ‚ÿÛÿþõÿû‚ÿäÿûõÿûòÿûìÿgHgHûÿgHgHgH¡ÿgHòÿgHgHªÿgHgHòÿgHgHgH¤ÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿšÿûÔÿøòÿ×Ýÿø‚ÿ´ÿæ‚ÿáÿûòÿþ‚ÿÛÿþõÿû‚ÿäÿûòÿþòÿþéÿgHgHûÿgHgHgH¡ÿgHgHõÿgHgHªÿgHgHòÿgHgHgH¤ÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿšÿûÔÿøòÿ×Ýÿø‚ÿ¢ÿþ‚ÿØÿþòÿþ‚ÿÛÿþõÿû‚ÿäÿûòÿþòÿþéÿgHgHûÿgHgHgH¡ÿgHgHõÿgHgHªÿgHgHòÿgHgHgH¤ÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿšÿûÑÿûïÿþàÿþÝÿøéÿì‚ÿÏÿþ‚ÿØÿþõÿþ‚ÿØÿþõÿû‚ÿäÿûïÿþõÿþÝÿgHgHgHÿgHgHªÿgHgHŒÿgHgHgHõÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿû¹ÿþ¹ÿøìÿì‚ÿÌÿþ‚ÿÕÿûþÿû‚ÿÕÿò‚ÿáÿûïÿûþÿû‚ÿ‚ÿÿgHgHŒÿgHgHgHõÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿßÿgHgH‚ÿöÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿßÿgHgH‚ÿöÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿû¡ÿø×ÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿßÿgHgH‚ÿöÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿû¼ÿõõÿòÚÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿßÿgHgH‚ÿöÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿû¼ÿûòÿõþÿûÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÈÿgHgHgH‚ÿ¥ÿgHgHgHòÿgHgHgHÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿû¼ÿþòÿõøÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÈÿgHgHgH•ÿgHgHgH›ÿgHgHgHòÿgHgHgHÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿû¿ÿþïÿøòÿþàÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÈÿgHgHgHûÿgHgHgH¤ÿgHgHgHõÿgHgH­ÿgHgHgHòÿgHgHgHÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿû¿ÿþòÿøïÿþàÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÈÿgHgHgHûÿgHgHgHÿgHgH•ÿgHgHgH¤ÿgHgHgHõÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿû¿ÿûøÿõòÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÈÿgHgHgH‚ÿÿgHgHgH¤ÿgHgHòÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿû¼ÿûþÿõïÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÈÿgHgHgH‚ÿÿgHgHgHÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿû¼ÿìòÿûÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÈÿgHgHgH‚ÿÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ³ÿû¶ÿøõÿòÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÈÿgHgHgH‚ÿÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ³ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÈÿgHgHgH‚ÿÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ³ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÈÿgHgHgH‚ÿ¥ÿgHgHgHòÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ³ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÈÿgHgHgH•ÿgHgHgH›ÿgHgHgHòÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ³ÿû•ÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÈÿgHgHgHøÿgHgH¤ÿgHgHgHõÿgHgH­ÿgHgHgHòÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ³ÿû¶ÿÝÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¶ÿgHgH¤ÿgHgHgHõÿgHgH‚ÿ®ÿgHgHòÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿû¼ÿ×Ýÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÒÿgHgHgHõÿgHgH‚ÿ®ÿgHgHòÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿû¿ÿÔÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÒÿgHgHgH‚ÿ‡ÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿû¿ÿøàÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÒÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ«ÿû¿ÿû¶ÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÒÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ«ÿû¼ÿþ¶ÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÒÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ«ÿû¹ÿþ¹ÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÒÿgHgHgH›ÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ›ÿû¹ÿþàÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿgHgH¡ÿgHgH’ÿgHgHgH›ÿgHgHgHïÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ³ÿû¶ÿÝÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ²ÿgHgHgH¡ÿgHgHõÿgHgH¤ÿgHgHgHõÿgHgHgH°ÿgHgHgHïÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ³ÿû¼ÿ×Ýÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ²ÿgHgHgHÿgHgH¤ÿgHgHgHõÿgHgHgH‚ÿ±ÿgHgHòÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿû¼ÿ×Ýÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¶ÿgHgHÿgHgHgH‚ÿ±ÿgHgHòÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿû¹ÿþàÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¶ÿgHgHÿgHgHgH‚ÿ±ÿgHgHòÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¶ÿgHgHÿgHgHgH‚ÿ±ÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ—ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¶ÿgHgHÿgHgHgH‚ÿ±ÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ—ÿû¡ÿþÑÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¶ÿgHgHÿgHgHgH‚ÿ±ÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ—ÿû¶ÿøòÿû×ÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¶ÿgHgHÿgHgHgH°ÿgHgH‰ÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ—ÿû¹ÿõïÿþ×ÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿµÿgHgHgH¡ÿgHgHgHõÿgHgH¤ÿgHgHgHõÿgHgHgH°ÿgHgHìÿgHgH¤ÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ—ÿû¼ÿòìÿþÚÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿµÿgHgHgHgHgH§ÿgHgHgHõÿgHgH¤ÿgHgHgHõÿgHgHgH°ÿgHgHìÿgHgHgH§ÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ—ÿû¼ÿøþÿþìÿûÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿµÿgHgHgHgHgH’ÿgHgH¤ÿgHgHgHõÿgHgHgH°ÿgHgHìÿgHgH¤ÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ—ÿû¿ÿûøÿþìÿûÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿµÿgHgHgH‚ÿ“ÿgHgHgH°ÿgHgH‰ÿgHgHòÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿû¿ÿûøÿþìÿøàÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿµÿgHgHgH‚ÿ‚ÿ¸ÿgHgHÿÿÿ‚ÿüÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿû¿ÿûøÿþìÿøàÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿµÿgHgHgH‚ÿ‚ÿ¸ÿgHgHÿÿÿ‚ÿüÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿû¼ÿþøÿþìÿøàÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿµÿgHgHgH‚ÿ‚ÿ»ÿgHgHgHÿÿÿ‚ÿüÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿû¼ÿþøÿþòÿõÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿµÿgHgHgH‚ÿ‚ÿ»ÿgHgHgHÿÿÿ‚ÿüÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿû¹ÿûþÿþøÿòÚÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿµÿgHgH‚ÿ‚ÿ¸ÿgHgHÿÿÿÿ‚ÿüÿgHgHgH§ÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ“ÿû¶ÿàÚÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿµÿgHgHžÿgHgHgH’ÿgHgH›ÿgHgHÿÿÿÿõÿgHgHgH’ÿgHgHgH§ÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ“ÿû³ÿéÔÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿµÿgHgHgHgHgH§ÿgHgHgHõÿgHgHgH§ÿgHgHïÿgHgH³ÿgHgHÿÿÿÿõÿgHgHgH’ÿgHgHgH§ÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ“ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿµÿgHgHþÿgHgH§ÿgHgHgHõÿgHgHgH§ÿgHgHïÿgHgH¬ÿ ÿÿÿõÿgHgHgHªÿgHgHgHïÿgHgH§ÿgHgH‚ÿ‚ÿ‚ÿ‚ÿÿû˜ÿþÚÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿgHgH§ÿgHgHgHõÿgHgHgHÿgHgH¬ÿ ÿÿÿÿøÿgHgHgHªÿgHgHgHïÿgHgH§ÿgHgH‚ÿ‚ÿ‚ÿ‚ÿÿû¼ÿþÝÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿgHgH§ÿgHgHgH‚ÿžÿ ÿÿÿÿøÿgHgHgHªÿgHgHgHïÿgHgH§ÿgHgH‚ÿ‚ÿ‚ÿ‚ÿÿû¼ÿþÝÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿgHgH§ÿgHgHgH‚ÿžÿ ÿÿÿÿøÿgHgHgH‚ÿ±ÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿÿû¼ÿþàÿøàÿø‚ÿ‚ÿ‚ÿ‚ÿ®ÿgHgH†ÿgHgH§ÿgHgHgH‚ÿ¡ÿÿÿÿÿÿøÿgHgHgH‚ÿ±ÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿÿûÈÿÈàÿø‚ÿ‚ÿ‚ÿ‚ÿ®ÿgHgHgH‰ÿgHgH§ÿgHgHgH‚ÿ¡ÿÿÿÿÿÿøÿgHgHgH‚ÿ±ÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿÿûÅÿÎÝÿø‚ÿ‚ÿ‚ÿ‚ÿ®ÿgHgHgH‰ÿgHgH§ÿgHgHgH‚ÿ¡ÿÿÿÿÿÿøÿgHgHgH‚ÿ±ÿgHgHgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ–ÿûÂÿÔÚÿø‚ÿ‚ÿ‚ÿ‚ÿ®ÿgHgH’ÿgHgHgHþÿgHgHgHªÿgHgHgH‚ÿ¥ÿgHÿÿÿÿÿÿøÿgHgHgH‚ÿ±ÿgHgHgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ–ÿû¿ÿû¶ÿø‚ÿ‚ÿ‚ÿ‚ÿ®ÿgHgH’ÿgHgHgHþÿgHgHgHªÿgHgHgHõÿgHgHgHªÿgHgHgH›ÿgHÿÿÿÿÿÿøÿgHgHgH‚ÿ«ÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ–ÿû¼ÿþ¶ÿø‚ÿ‚ÿ‚ÿ‚ÿ®ÿgHgH’ÿgHgHgHþÿgHgHgHªÿgHgHgHõÿgHgHgHªÿgHgHgHïÿgHgHgH²ÿÿÿïÿgHgHgHªÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ—ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ®ÿ gHgHgHgH‚ÿ–ÿgHgHgHªÿgHgHgHïÿgHgHgH²ÿÿÿÿgHgHgHïÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿû•ÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ®ÿ gHgHgHgH‚ÿ‚ÿµÿgHgHgH—ÿÿÿÿgHgHgHïÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ²ÿû•ÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ®ÿ gHgHgHgH‚ÿ‚ÿµÿgHgHgH—ÿÿÿ‚ÿóÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ²ÿû¹ÿÚÝÿø‚ÿ‚ÿ‚ÿ‚ÿ®ÿgHgH‚ÿ‚ÿ¯ÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¨ÿû¼ÿ×Ýÿø‚ÿ‚ÿ‚ÿ‚ÿ®ÿgHgH‚ÿ‚ÿ¯ÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¨ÿû¿ÿõãÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ±ÿgHgHgH‚ÿ‚ÿ¯ÿgHgHgH‹ÿÿ‚ÿŸÿgHgHgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ–ÿû¿ÿøàÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿËÿgHgHgH•ÿgHgHgH¸ÿÿéÿgHgHgHýÿÿÿõÿgHgH‚ÿ±ÿgHgHþÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ–ÿû¿ÿû¶ÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿgHgHgHþÿgHgHgHªÿgHgHgHòÿgHgHªÿgHgHgH»ÿ ÿÿÿìÿgHgHgHýÿÿÿõÿgHgH‚ÿ¨ÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ–ÿû¼ÿþ¶ÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿgHgHgHþÿgHgHgHªÿgHgHgHòÿgHgHªÿgHgHgHïÿgHgHgHÓÿÿÿéÿgHgHúÿÿõÿgHgHªÿgHgH‚ÿ„ÿgHgH‚ÿ‚ÿ‚ÿ˜ÿû¹ÿþ¹ÿø‚ÿ‚ÿ‚ÿ‚ÿ¨ÿgHgHgHÿgHgHÿgHgHÿgHgHgHÓÿÿÿëÿÿÿúÿÿ˜ÿgHgHìÿgHgHgH‚ÿ¢ÿgHgH‚ÿ‚ÿ‚ÿ˜ÿû¶ÿþãÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ¨ÿgHgHgH‚ÿ–ÿgHgHgH’ÿgHgHgHÓÿÿÿëÿÿÿúÿÿ˜ÿgHgHìÿgHgHgH‚ÿ¥ÿgHgHgH‚ÿ‚ÿ‚ÿ˜ÿû¿ÿÔÝÿø‚ÿ‚ÿ‚ÿ‚ÿ¨ÿgHgHgH‚ÿ–ÿgHgHgH’ÿgHgHgHÓÿÿÿëÿÿÿúÿÿ›ÿgHgHgHìÿgHgHgHñÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÄÿû¼ÿ×Ýÿø‚ÿ‚ÿ‚ÿ‚ÿ±ÿgHgHgH‚ÿÿgHgHgH’ÿgHgHgHÓÿÿÿëÿÿÿúÿÿ›ÿgHgHgHÖÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿû¼ÿ×Ýÿø‚ÿ‚ÿ‚ÿ‚ÿ±ÿgHgHgH‚ÿÿgHgHgH’ÿgHgHgHÐÿÿëÿþÿÿÿýÿÿÿžÿgHgHgHÖÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿû•ÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ±ÿgHgHgH‚ÿÿgHgHgH’ÿgHgHgHÖÿýÿÿëÿþÿÿÿýÿÿÿžÿgHgHgHÖÿÿÿÅÿgHgHgHþÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ™ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ³ÿgHgHgH’ÿgHgHgHÖÿ ÿÿÿìÿ ÿÿÿÿýÿÿÿžÿgHgHgHÙÿ ÿÿÿÅÿgHgHgHþÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ™ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿgHgHgHþÿgHgHgHªÿgHgHïÿgHgHgH­ÿgHgHgHïÿgHgHgHÙÿ ÿÿÿÿìÿÿÿÿúÿÿÿøÿgHgH­ÿgHgHgHÙÿ ÿÿÿÂÿgHgHþÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ™ÿû•ÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿgHgHûÿgHgHgHªÿgHgHïÿgHgHgH­ÿgHgHgHïÿgHgHgHÙÿÿÿÿÿÿïÿÿÿÿúÿÿÿøÿgHgH­ÿgHgHgHÓÿÿÿ¼ÿgHgHgHÿgHgHgHgHgH‚ÿ‚ÿ‚ÿ›ÿû•ÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ¨ÿgHgHgH›ÿgHgHûÿgHgHgH’ÿgHgHgH’ÿgHgHgHÙÿÿÿÿÿÿïÿÿþÿùÿÿÿžÿgHgHgHéÿgHgHñÿÿÿ¼ÿgHgHgHÿgHgHgHgHgH‚ÿ‚ÿ‚ÿ›ÿûÑÿþÈÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ¨ÿgHgHgH›ÿgHgH‚ÿ‚ÿØÿÿÿÿÿÿïÿ ÿÿÿüÿÿÿžÿgHgHgHéÿgHgHñÿÿÿ¼ÿgHgHgHÿgHgHgHgHgH‚ÿ‚ÿ‚ÿ›ÿûÑÿÂÝÿø‚ÿ‚ÿ‚ÿ‚ÿ¨ÿgHgHgH›ÿgHgH‚ÿ‚ÿØÿÿÿÿÿÿïÿ ÿÿÿüÿÿÿ‚ÿüÿgHgHñÿÿÿ¼ÿgHgHgH†ÿgHgH‚ÿ‚ÿ‚ÿ›ÿûÑÿÂÝÿø‚ÿ‚ÿ‚ÿ‚ÿ´ÿgHøÿgHgHgH›ÿgHgH‚ÿ‚ÿØÿÿÿÿÿÿïÿ ÿÿÿüÿÿÿ‚ÿüÿgHgHñÿÿÿ¼ÿgHgHgH†ÿgHgH‚ÿ‚ÿ‚ÿ›ÿûÑÿÂÝÿø‚ÿ‚ÿ‚ÿ‚ÿ´ÿgHgHgHþÿgHgHgH›ÿgHgH‚ÿ‚ÿØÿÿÿæÿÿÿÿÿÿ²ÿÿÈÿgHgHñÿÿÿ¼ÿgHgHgH†ÿgHgH‚ÿ‚ÿ‚ÿ›ÿûÑÿþËÿûÝÿø‚ÿ‚ÿ‚ÿ‚ÿ´ÿgHgHgHþÿgHgHgH›ÿgHgH‚ÿ‚ÿùÿÿåÿÿæÿÿþ ÿÿÿÿ´ÿ ÿÿÿËÿgHgH÷ÿ ÿÿÿÿÈÿgHgHgHþÿgHgHgH†ÿgHgH‚ÿ‚ÿ‚ÿ›ÿûÑÿþÈÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ¨ÿgHgHgHžÿgHgHgH‚ÿ‚ÿùÿÿÿèÿÿæÿÿÿÿÿÿ´ÿ ÿÿÿËÿgHgH÷ÿ ÿÿÿÿÈÿgHgHgHþÿgHgHgH†ÿgHgH‚ÿ‚ÿ‚ÿ›ÿû•ÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ¨ÿgHgHgHžÿgHgHgHøÿgHgH­ÿgHgHgH’ÿgHgHgHßÿÿÿèÿÿæÿÿÿÿÿÿîÿgHgHgHÍÿÿÿËÿgHgH÷ÿÿ¿ÿgHgHgHþÿgHgHgH†ÿgHgH‚ÿ‚ÿ‚ÿ›ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¨ÿgHgHgHžÿgHgHgHøÿgHgH­ÿgHgHgHïÿgHgHgH­ÿgHgHgHìÿgHgHýÿ ÿÿÿèÿÿæÿÿÿÿÿÿîÿgHgHgHÍÿÿÿËÿgHgH÷ÿÿ¿ÿgHgHgHƒÿgHgHþÿgHgH‚ÿ‚ÿ‚ÿ›ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¨ÿgHgHgHŒÿgHgH­ÿgHgHgHïÿgHgHgHÿgHgHýÿ ÿÿÿèÿÿæÿÿÿýÿÿîÿgHgHgHÍÿÿÿìÿgHgHgHéÿgHgH÷ÿÿ¿ÿgHgHgHƒÿgHgHgHgHgHgH‚ÿ‚ÿ‚ÿžÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¨ÿgHgHgHŒÿgHgHgH°ÿgHgHgH‚ÿéÿ ÿÿÿëÿÿÿæÿÿÿýÿÿÿÿÿÿøÿgHgHgHÊÿÿìÿgHgHgHúÿÿõÿgHgHúÿÿÿ¿ÿgHgH‚ÿÿÿgHgHgHgHgHgH‚ÿ‚ÿ‚ÿžÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¨ÿgHgHgHŒÿgHgHgH°ÿgHgHgH‚ÿéÿ ÿÿÿÿîÿÿÿýÿÿÿòÿÿúÿÿÿÿÿÿøÿgHgHgHÊÿÿßÿÿÿõÿgHgHúÿÿÿ¿ÿgHgH‚ÿ ÿÿgHgHgH‚ÿ‚ÿ‚ÿ•ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ©ÿgHgHgH°ÿgHgHgH‚ÿéÿ ÿÿÿÿîÿÿÿúÿÿûÿ ÿÿÿÿúÿÿÿÿÿÿøÿgHgHgHÊÿÿßÿÿÿèÿÿÿ¿ÿgHgH‚ÿ ÿÿgHgHgH‚ÿ‚ÿ‚ÿ•ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ´ÿgHgHgH‚ÿ ÿÿgHgHgH°ÿgHgHgH‚ÿéÿ ÿÿÿÿßÿÿþÿÿÿÿÿÿúÿÿÿÿÿÿøÿgHgHgHÐÿ ÿÿÿÿâÿ ÿÿÿëÿÿÿ¿ÿgHgH‚ÿ ÿÿgHgHgH‚ÿ‚ÿ‚ÿ•ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ´ÿgHgHgH‚ÿ ÿÿgHgHgH°ÿgHgHgH‚ÿéÿ ÿÿÿÜÿÿþÿþÿÿÿÿÿÿÿþÿÿÿÿÿÿøÿgHgHgHÐÿ ÿÿÿÿâÿ ÿÿÿëÿÿÿýÿÿÈÿgHgH‚ÿ ÿÿgHgHgH‚ÿ‚ÿ‚ÿ•ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ´ÿgHgHgH‚ÿ ÿÿgHgHgH°ÿgHgHgH‚ÿ¹ÿÿþÿþÿÿÿÿÿÿÿþÿÿÿÿÿÿøÿgHgHgHñÿåÿÿÿÿÿÿâÿ ÿÿÿëÿÿÿýÿÿÿËÿgHgHûÿgHgHgHÿgHgHgH‚ÿ‚ÿ‚ÿ•ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ´ÿgHgHgH’ÿgHgHgHøÿgHgHgH°ÿgHgHgH’ÿgHgH¯ÿÿþÿþÿÿüÿÿÿþÿÿÿÿÿÿøÿgHgHgH÷ÿÿÿåÿÿÿÿÿÿåÿÿÿåÿÿÿýÿÿÿËÿgHgHøÿgHgHÿgHgH‚ÿ‚ÿ‚ÿ’ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ´ÿgHgHgH’ÿgHgHgHøÿgHgHgH°ÿgHgHgHïÿgHgHgH­ÿgHgHéÿgHgHgHÐÿþÿÿþÿýÿ ÿÿÿÿþÿÿÿÿÿÿøÿgHgHgH÷ÿÿÿåÿÿÿÿÿÿåÿÿÿåÿÿÿýÿÿÿ‚ÿÃÿgHgH‚ÿ‚ÿ‚ÿ’ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ´ÿgHgHgH‚ÿ ÿÿgHgHgH•ÿgHgHgH­ÿgHgHéÿgHgHgHÐÿþÿþÿÿýÿ ÿÿÿÿûÿ ÿÿÿÿåÿÿÿåÿÿÿÿÿÿïÿgHgHgHÿÿÿòÿgHgHúÿÿÿýÿÿÿ‚ÿÃÿgHgHþÿgHgHgH‚ÿ‚ÿ‚ÿžÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ´ÿgHgHgHûÿgHgHgH‚ÿÿ³ÿgHgHgHéÿgHgHæÿÿúÿÿÿúÿþÿþÿÿýÿ ÿÿÿÿûÿ ÿÿÿÿèÿ ÿÿÿåÿÿÿÿÿÿïÿgHgHgHÿÿÿòÿgHgHúÿÿúÿÿÿ‚ÿÃÿgHgHþÿgHgHgH‚ÿ‚ÿ‚ÿžÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ´ÿgHgHgHûÿgHgHgH‚ÿ’ÿÿÿ¶ÿgHgHgHÑÿÿýÿÿÿýÿÿÿúÿþÿþÿÿùÿÿÿûÿ ÿÿÿÿèÿ ÿÿÿåÿÿÿÿÿÿìÿgHgHÿÿÿòÿgHgHÿÿÿÿúÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÍÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ´ÿgHgHgH‚ÿƒÿÿÿ¶ÿgHgHgHâÿÿÿýÿÿý ÿÿÿÿÿýÿÿÿúÿþÿþÿöÿÿÿûÿÿÿÿÿÿþÿÿÿ÷ÿ ÿÿÿÿåÿÿÿÜÿÿÿìÿ ÿÿÿÿúÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÍÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ´ÿgHgHgH‚ÿƒÿÿÿ¶ÿgHgHgHâÿÿÿýÿýÿÿÿÿÿÿÿÿÿÿúÿþÿþÿöÿÿÿûÿ ÿÿÿÿý ÿÿÿÿ÷ÿÿÿÿÿÿèÿÿÿÜÿÿÿìÿÿÿÿ÷ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÍÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ´ÿgHgHgH‚ÿ†ÿ ÿÿÿ¶ÿgHgHgHâÿÿÿýÿýÿÿÿÿÿÿÿÿÿÿúÿþÿþÿöÿÿÿûÿÿÿÿÿÿÿÿÿÿúÿÿÿÿÿÿèÿÿÙÿ ÿÿÿÿøÿÿÿÿÿÿ÷ÿÿÿÎÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿŠÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ´ÿgHgHgH‚ÿ†ÿ ÿÿÿÿßÿÝÿgHgHgHâÿÿÿýÿýÿÿÿÿÿÿÿÿÿÿøÿÿþÿöÿÿÿûÿÿÿÿÿÿÿÿÿÿúÿÿÿÿÿÿèÿÿÐÿÿÿûÿÿÿÿÿÿ÷ÿÿÿÎÿgHgHgHøÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿœÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ»ÿgHgHgHžÿgHgHgHåÿÿÿâÿÿÿàÿgHgHgHâÿÿÿýÿýÿÿÿÿÿÿýÿÿõÿÿþÿöÿÿÿûÿÿÿÿÿÿÿÿÿÿgHýÿÿÿÿÿÿèÿÿÐÿÿÿûÿÿÿÿÿÿôÿÿÎÿgHgHgHøÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿœÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ»ÿgHgHgHõÿgHgHÜÿ×ÿgHgHgHìÿgHgHÿÿÿâÿÿÿàÿgHgHgHéÿgHgHÿÿÿýÿýÿÿÿÿÿÿþÿÿ÷ÿÿþÿÿöÿÿÿûÿÿþÿÿÿÿÿÿÿÿgHýÿÿÿÿÿÿèÿÿÐÿÿÿûÿÿÿÿÿÿôÿÿ¼ÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿœÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¦ÿgHgHßÿÿÿ¼ÿgHgHÿÿÿåÿ ÿÿÿâÿ ÿÿgHéÿgHgHÿÿÿýÿý ÿÿÿÿýÿ ÿÿÿúÿÿþÿÿöÿÿÿøÿÿÿÿÿÿÿÿÿúÿÿýÿÿÿèÿÿúÿÿïÿgHgHôÿÿÿûÿÿÿÿÿÿôÿÿ‚ÿÆÿgHgHgHûÿgHgHgH‚ÿ‚ÿ‚ÿ¡ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¥ÿgHgHgH‚ÿæÿ ÿÿÿ¼ÿgHgHÿÿÿåÿÿÿßÿÿãÿ gHgHÿÿûÿÿÿÿÿÿýÿ ÿÿÿúÿÿþÿÿöÿÿÿøÿÿþÿýÿ ÿÿÿÿúÿÿýÿÿÿèÿÿúÿÿòÿgHgHgHôÿÿÿþÿÿÿÿÿÿÿþÿÿüÿÿ‚ÿÆÿgHgHgHûÿgHgHgH‚ÿ‚ÿ‚ÿ¡ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¥ÿgHgHgH‚ÿæÿ ÿÿÿ¼ÿgHgHÿÿÿåÿÿÿâÿÿÿãÿ gHgHÿÿûÿ ÿÿÿÿþÿÿÿÿÿÿÿúÿÿÿöÿÿÿøÿÿøÿ ÿÿÿÿúÿÿýÿÿÿèÿÿúÿÿòÿgHgHgHôÿÿÿþÿÿÿÿÿÿÿþÿÿüÿÿ‚ÿÃÿgHgHûÿgHgHgH‚ÿ‚ÿ‚ÿ¡ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¥ÿgHgHgH‚ÿæÿ ÿÿÿ¼ÿgHgHgHÿÿåÿÿÿâÿÿÿãÿ gHgHÿÿþÿÿþÿÿÿÿþÿÿÿÿÿÿÿúÿÿÿöÿÿÿòÿÿÿþÿ ÿÿÿÿýÿÿýÿÿÿÜÿÿÿõÿgHgHgHÿÿÿýÿÿÿþÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÆÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ´ÿgHgH‚ÿÔÿ ÿÿÿ»ÿ ÿgHÿÿåÿÿßÿÿÿãÿ gHgHÿÿûÿ ÿÿÿÿþÿÿÿÿÿÿÿúÿÿÜÿÿÿÿþÿÿÿÿÿÿÿýÿÿÿÜÿÿÿõÿgHgHgHÿÿÿúÿÿþÿÿýÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÆÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ´ÿgHgH‚ÿÔÿ ÿÿÿ»ÿÿgHÿÿÿèÿÿßÿÿÿýÿéÿ gHgHÿÿþÿÿþÿÿÿþÿÿþ ÿÿÿÿÿþÿúÿÿÜÿÿÿÿþÿÿÿÿÿÿÿÐÿÿÿõÿgHgHgHÿÿÿúÿÿþÿÿÿÿþÿÿÿÿÿÿÇÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿŠÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ·ÿgHgHgH‚ÿÔÿ ÿÿÿÿ¾ÿ ÿgHÿåÿÿÿßÿ ÿÿÿÿéÿ gHgHÿÿûÿÿÿÿþÿÿþ ÿÿÿÿÿþÿúÿÿØÿþÿÿÿÿÿÿÿÿÚÿÿúÿÿÿõÿgHgHgHÿÿÿúÿÿý ÿÿÿÿþÿÿÿÿþÿÿÇÿgHgHgHøÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿœÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ»ÿgHgHÍÿ ÿÿÿÿÝÿgHgHèÿÿgHâÿÿÿßÿ ÿÿÿÿéÿ gHgHÿÿûÿÿÿÿþÿÿÿþÿÿþÿÿþÿÿýÿÿÿÿøÿgHgHîÿÿþÿÿÿÿÿÿÿÿàÿÿÿÿúÿÿÿõÿgHgHgHÿÿÿúÿÿý ÿÿÿÿýÿþÿÿþÿÿÇÿgHgHgHøÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿœÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ»ÿgHgHòÿgHgHâÿÿÿ×ÿgHgHëÿ ÿÿgHâÿÿÿÿÿÿèÿ ÿÿÿÿéÿ gHgHÿÿþÿÿÿÿÿÿÿúÿþÿÿþÿÿÿÿÿÿÿøÿgHgHîÿÿþÿÿÿÿÿÿÿÿàÿÿÿÿúÿÿÿõÿgHgHgHÿÿÿúÿÿýÿÿùÿþÿÿþÿÿµÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿœÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ»ÿgHgHòÿgHgHâÿÿÿ»ÿ ÿÿgHâÿÿÿÿÿÿèÿÿÿÿÿÿìÿ gHgHÿÿþÿ ÿÿÿÿòÿÿÿþÿÿÿÿÿÿÿøÿgHgHîÿÿûÿÿÿÿÖÿþÿþÿüÿÿÿõÿgHgHgHÿÿÿúÿÿýÿÿýÿgHÿþÿÿþÿÿÿÿÿÿ¿ÿgHgHgH•ÿgHgHgHûÿgHgHgH‚ÿ‚ÿ‚ÿ¡ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¥ÿgHgHgH¡ÿgHgH‚ÿþÿÿÿßÿÿÿÿÿÿèÿÿýÿÿÿìÿ gHgHÿÿþÿÿÿîÿÿÿÿþÿÿÿÿÿÿúÿÿÿîÿÿûÿÿÒÿýÿÿüÿÿÿõÿgHgHgHÿÿÿúÿÿýÿÿÿgHgHÿÿÿþÿÿÿÿÿÿ¿ÿgHgHgH•ÿgHgHgHûÿgHgHgH‚ÿ‚ÿ‚ÿ¡ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¥ÿgHgHgH¡ÿgHgH‚ÿþÿÿÿßÿÿÿýÿÿèÿÿýÿÿÿãÿÿÿþÿÿëÿÿÿþÿÿÿÿÿÿúÿÿÿîÿÿûÿÿíÿÿÿõÿÿýÿýÿÿÿüÿÿõÿgHgHgHÿÿ÷ÿÿýÿÿÿgHgHÿÿÿþÿÿÿÿÿÿ¿ÿgHgHgH•ÿgHgHgHûÿgHgHgH‚ÿ‚ÿ‚ÿ¡ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¥ÿgHgHgH¤ÿgHgHgH‚ÿþÿÿÿÓÿÿèÿÿýÿÿÿãÿÿÿþÿÿëÿÿÿþÿÿÿÿÿÿúÿÿÿîÿÿûÿÿíÿÿÿõÿÿÿÿþÿÿÿüÿÿëÿÿòÿÿÿÿgHgHÿÿûÿÿÿÿÿÿ¿ÿgHgHgH†ÿgHgHgH’ÿgHgH‚ÿ‚ÿ—ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ·ÿgHgHgHøÿgHgHgH¤ÿgHgHgH‚ÿþÿÿÿýÿÿÿßÿÿëÿÿÿýÿÿÿãÿÿÿþÿÿëÿÿÿþÿÿÿÿÿÿúÿÿÿîÿÿûÿÿÿðÿÿÿõÿÿÿÿþÿÿÿÿÿÿÿëÿÿþÿÿøÿÿÿÿgHgHÿÿþÿÿþÿÿÿÿÿÿÂÿgHgHgH†ÿgHgHgH’ÿgHgHgH‚ÿ‚ÿšÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ·ÿgHgHgHõÿgHgH¤ÿgHgHgHÄÿÿÿÄÿÿÿýÿÿÿßÿÿëÿÿÿýÿÿÿãÿÿÿþÿÿëÿÿÿÿþÿüÿÿúÿÿgHîÿÿÿþÿÿÿðÿÿÿïÿÿÿÿÿÿÿÿÿëÿþÿÿÿûÿÿÿÿÿgHgHÿÿþÿÿþÿÿÿÿÿÿÔÿgHgHõÿgHgHgH†ÿgHgHgH’ÿgHgHgH‚ÿ‚ÿšÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ·ÿgHgHgHõÿgHgH¤ÿgHgHgHÄÿÿÿÄÿÿÿýÿÿÿßÿÿÿîÿÿÿýÿÿÿãÿÿÿþÿÿðÿÿþÿÿÿ÷ÿÿúÿÿgHîÿÿÿþÿÿÿÿÿÿÿúÿÿÿïÿÿÿÿÿÿÿÿÿëÿþ ÿÿÿÿþÿÿÿÿÿgHÿÿÿûÿÿÿÿÿÿÿÔÿgHgHõÿgHgHgH†ÿgHgHgHÿgHgH‚ÿ‚ÿšÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¢ÿgHgH¤ÿgHgHgHÄÿÿÿãÿgHgHgHëÿÿÿýÿÿÿßÿÿÿëÿÿgHÿÿÿãÿÿÿþÿíÿÿþÿÿÿ÷ÿÿúÿÿgHîÿÿÿþÿÿÿÿÿÿ÷ÿÿÿïÿÿÿÿÿÿÿÿÿëÿþ ÿÿÿÿþÿÿÿÿÿgHÿÿÿøÿÿÿÿÿÿÔÿgHgHõÿgHgHgH†ÿgHgHgH‚ÿ‚ÿ‚ÿ¡ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¢ÿgHgH¤ÿgHgHgHòÿgHgHgHèÿÿÿýÿÿÿãÿgHgHgHëÿÿÿgHÿÿÿßÿÿÿæÿ gHÿÿÿèÿÿþÿþÿÿÿÿÿÿ÷ÿÿþÿÿÿÿúÿÿúÿÿgHîÿÿÿûÿ ÿÿÿÿ÷ÿÿÿòÿ ÿÿÿÿþÿÿ÷ÿÿòÿÿÿÿÿÿþÿÿÿÿÿgHgHgHõÿ ÿÿÿÿÿþÿÙÿgHgHõÿgHgHgH†ÿgHgHgH‚ÿ‚ÿ‚ÿ¡ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¢ÿgHgH¤ÿgHgHgHòÿgHgHgHèÿÿÿýÿÿÿãÿgHgHgHëÿ ÿÿgHýÿÿëÿÿúÿÿÿæÿ gHÿÿÿèÿÿþÿþÿÿÿÿÿÿ÷ÿÿþÿÿÿÿúÿÿúÿÿëÿÿÿûÿ ÿÿÿÿôÿÿþÿÿÿýÿ ÿÿÿÿþÿÿúÿÿÿÿþÿ gHgHgHÿþ ÿÿÿÿþÿÿÿÿÿgHgHgHõÿ ÿÿÿÿþÿÿÿÜÿgHgH‚ÿÿÿgHgHøÿgHgHgH‚ÿ‚ÿ‚ÿ¡ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¢ÿgHgHŒÿgHgHgHèÿÿÿýÿÿÿãÿgHgHgHëÿ ÿÿgHýÿÿëÿÿúÿÿÿâÿÿÿèÿÿþÿþÿÿÿÿÿÿúÿÿÿûÿÿ÷ÿÿÿýÿÿëÿÿÿûÿÿÿÿÿÿùÿÿþÿÿÿÿÿÿÿÿÿÿþÿúÿÿÿÿþÿ gHgHgHÿþ ÿÿÿÿÿýÿÿýÿgHgHgHõÿ ÿÿÿÿþÿÿÿßÿgHgHgH‚ÿÿÿgHgHõÿgHgHŒÿgHgH‚ÿ‚ÿÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¢ÿgHgHgHÿgHgHgHèÿÿÿýÿÿÿãÿgHgHgHèÿÿúÿÿîÿÿÿúÿÿÿâÿÿÿèÿÿþÿþÿÿüÿÿúÿÿÿîÿÿÿýÿÿëÿÿÿûÿÿÿÿÿÿùÿÿýÿÿÿÿÿÿÿÿÿÿþÿÿýÿÿÿÿþÿgHgHgHÿÿÿÿýÿÿÿýÿgHgHgHõÿ ÿÿÿÿþÿÿÿßÿgHgHgH‚ÿÿÿgHgHõÿgHgHÿgHgHgH‚ÿ‚ÿÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¢ÿgHgHgHÿgHgHgHèÿÿÿþÿÿÿÿãÿgHgHgHÜÿÿÿñÿÿÿúÿÿÿâÿÿÿèÿÿþÿþÿÿüÿÿúÿÿÿîÿÿÿÿÿÿëÿÿÿøÿ ÿÿÿÿùÿÿýÿÿÿÿÿÿÿÿÿÿþÿÿýÿÿÿÿõÿ ÿÿÿÿýÿÿÿÿæÿÿÿÿÿÿÿßÿgHgHgHƒÿgHgHgH‚ÿüÿgHgHgH‚ÿ‚ÿÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ·ÿgHgHgH‚ÿùÿgHgHgHèÿÿÿþÿÿÿÿãÿgHgHÙÿýÿÿóÿÿÿúÿÿþÿÿÿÇÿþÿÿþÿÿüÿÿúÿÿÿîÿÿÿÿÿÿèÿÿ÷ÿýÿÿý ÿÿÿÿÿþÿþÿÿÿÿÿÿÿÿþÿÿþÿÿýÿÿÿôÿÿÿÿÿÿÿÿâÿÿÿÿÿÿÿÿùÿÿïÿgHgHgHƒÿgHgHgHƒÿgHgHgH‚ÿ‚ÿ—ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ·ÿgHgHgH‚ÿùÿgHgHgHèÿÿÿþ ÿÿÿÿãÿgHgHÚÿÿÿÿÿÿ÷ÿÿÿúÿÿþÿÿÿôÿÿÿÜÿþÿÿþÿùÿÿÿýÿÿÿåÿÿÿÙÿÿÿýÿÿÿÿÿÿþÿÿÿÿþ ÿÿÿÿûÿ ÿÿÿÿþÿÿÿ÷ÿÿýÿÿÿÿÿÿÿæÿÿÿÿÿÿÿÿüÿ ÿÿÿòÿgHgHgHƒÿgHgHgHƒÿgHgHgH‚ÿ‚ÿ—ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ·ÿgHgHgH‚ÿùÿgHgHgHèÿÿÿþ ÿÿÿÿÿæÿgHgHàÿÿÿþÿÿÿÿÿÿÿÿÿÿÿòÿÿÿôÿÿÿÜÿþÿþÿÿùÿÿÿýÿÿÿåÿÿÖÿÿÿþÿ ÿÿÿÿÿþÿýÿÿÿÿÿÿûÿÿÿÿÿÿÿÿúÿÿþÿýÿÿÿÿÿÿÿúÿÿÿõÿ ÿÿÿÿÿþÿÿüÿ ÿÿÿòÿgHgHgHïÿgH˜ÿgHgHgHƒÿgHgHgH‚ÿ‚ÿ—ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ·ÿgHgHgH’ÿgHgHïÿgHgHgHèÿÿÿþÿÿþÿÿÿèÿÿgHÝÿÿþÿÿÿÿÿÿÿÿÿÿÿõÿÿÿóÿ ÿgHgHâÿÿþÿþÿÿùÿÿÿýÿÿåÿ ÿÿgHÙÿÿÿþÿ ÿÿÿÿýÿÿýÿÿÿïÿÿÿÿÿÿÿúÿÿþÿúÿÿÿÿÿÿúÿÿÿòÿ ÿÿÿÿþÿÿüÿ ÿÿÿòÿgHgHgHòÿgHgHgH›ÿgHgHgHƒÿgHgH‚ÿ‚ÿ”ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ·ÿgHgHgH’ÿgHgHìÿgHgHèÿÿþÿÿþÿÿÿçÿÿgHãÿgHgHÿþÿÿÿÿÿÿÿÿÿÿÿøÿ ÿÿÿÿöÿþ ÿÿÿgHåÿÿýÿÿöÿÿÿýÿÿßÿgHÚÿÿÿÿþÿ ÿÿÿÿýÿÿÿÿÿÿïÿ ÿÿÿÿÿþÿÿýÿÿÿúÿÿÿÿÿÿúÿÿÿãÿÿüÿ ÿÿÿÚÿgHgHgH›ÿgHgHgHƒÿgHgH‚ÿ‚ÿ”ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ·ÿgHgHgH’ÿgHgHìÿgHgHèÿÿþÿÿþÿÿÿçÿÿÿëÿÿþÿÿgHþÿÿÿÿýÿÿÿûÿÿÿ÷ÿ ÿÿÿÿ÷ÿÿÿÿÿgHåÿýÿÿÿöÿÿÿýÿÿ³ÿ ÿÿÿÿþÿÿÿÿýÿÿÿÿÿÿìÿ ÿÿÿÿþÿÿÿgHÿÿ÷ÿ ÿÿÿÿúÿÿàÿÿÿÿÿÿÿÿ‚ÿêÿgHgHgHõÿgHgHgH˜ÿgHgH‚ÿ‚ÿ”ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ·ÿgHgHòÿgHgHgH‚ÿìÿÿþÿÿþÿÿÿíÿýÿÿÿëÿÿþÿÿÿþÿÿÿÿýÿÿÿþÿ ÿÿÿúÿÿþÿÿÿÿÿýÿÿÿÿÿÿgHÿÿÿïÿ ÿÿÿóÿÿÿýÿÿ²ÿþÿÿÿþÿÿýÿÿýÿÿÿÿëÿÿÿþÿÿÿÿgHÿôÿ ÿÿÿÿþÿgHÿÿàÿÿÿÿÿÿÿÿ‚ÿêÿgHgHgHõÿgHgHgH˜ÿgHgHøÿgH‚ÿ‚ÿ ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ·ÿgHgHòÿgHgHgH‚ÿìÿÿþÿ ÿÿÿÿíÿ ÿÿÿÿëÿÿþÿÿÿþÿÿýÿÿÿýÿ ÿÿÿúÿÿþÿÿÿÿÿýÿÿÿÿÿÿgHÿÿÿïÿÿÿðÿÿÿýÿÿÁÿÿÿúÿþ ÿÿÿÿþÿýÿÿýÿÿÿÿëÿÿÿþÿÿþ ÿÿÿÿðÿÿÿþÿgHÿÿàÿÿÿüÿ ÿÿÿ‚ÿíÿgHgHgHõÿgHgHgH˜ÿgHgHþÿgHgHgH‚ÿ‚ÿ ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ·ÿgHgHòÿgHgHgH‚ÿïÿÿÿþÿþÿÿÿÿÿðÿ ÿÿÿÿìÿ ÿÿÿÿÿþÿÿýÿÿÿÿÿÿÿÿÿúÿÿÿÿÿÿýÿÿÿÿÿÿÿÿÿÿïÿÿÿíÿ ÿÿÿÿÁÿÿÿúÿþ ÿÿÿÿþ ÿÿÿÿýÿÿÿåÿÿþÿÿþ ÿÿÿÿðÿÿÿýÿÿÿãÿÿþ ÿÿÿÿýÿÿÿ‚ÿ‚ÿåÿgHgHþÿgHgHgH‚ÿ‚ÿ ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ·ÿgHgH‚ÿ×ÿÿÿþÿþÿýÿÿÿóÿÿÿÿÿÿìÿ ÿÿÿýÿÿÿýÿÿþÿÿÿÿÿÿÿýÿ ÿÿÿÿý$ÿÿÿÿÿÿÿÿÿÿÿÿÿïÿÿÿíÿÿýÿÿÁÿÿÿøÿ ÿÿÿÿþÿÿÿÿÿÿÿÿåÿÿþÿÿþ ÿÿÿÿðÿÿÿýÿÿÿãÿÿþÿÿÿÿÿÿÿÿ‚ÿ‚ÿåÿgHgHþÿgHgHgH‚ÿ‚ÿ ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ·ÿgHgH‚ÿ×ÿÿÿþÿþÿýÿÿÿóÿÿÿýÿÿïÿ ÿÿÿÿýÿÿúÿÿþ ÿÿÿÿÿýÿÿýÿ ÿÿÿÿþÿþ!ÿÿÿÿÿÿÿÿÿÿÿÿøÿÿûÿÿÿÿîÿÿÿ»ÿÿÿõÿÿÿþÿÿÿÿÿÿÿÿÿýÿÿîÿÿÿþÿþ ÿÿÿÿíÿÿýÿÿÿîÿÿÿþÿÿþÿÿÿÿÿÿÿÿ‚ÿ‚ÿåÿgHgHþÿgHgHgH‚ÿ‚ÿ ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ·ÿgHgH‚ÿÏÿÿþÿýÿÿþÿóÿÿÿýÿÿïÿÿÿÿÿÿÿÿÿÿÿÿþ ÿÿÿÿÿþÿÿýÿ ÿÿÿÿþÿþ ÿÿÿÿÿýÿÿÿÿÿÿÿþÿÿÿÿþÿ ÿÿÿÿîÿµÿÿÿéÿÿÿÿÿÿÿÿýÿÿîÿÿÿþÿÿþ ÿÿÿÿîÿÿýÿÿÿîÿÿÿþÿÿþÿÿÿÿÿÿÿÿõÿgHgH‚ÿ‚ÿ÷ÿgHgHûÿgHgH‚ÿ‚ÿ ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¾ÿgHgHÈÿÿÿýÿÿþÿóÿÿÿýÿÿïÿ"ÿÿÿÿÿÿÿÿÿÿÿÿþÿýÿÿÿþÿýÿ ÿÿÿÿþÿþ ÿÿÿÿÿÿý ÿÿÿÿÿýÿýÿÿÿÿþ ÿÿÿÿÿÅÿgHgHgHåÿÿûÿgHgHgHõÿÿÿþÿÿÿýÿÿÿîÿÿÿøÿÿÿÿîÿÿÿÿÿÿîÿÿÿøÿ ÿÿÿÿìÿgHgHïÿgHgHgH‚ÿ‡ÿgHgH‚ÿ‚ÿ ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¾ÿgHgHìÿgHgHãÿÿÿúÿÿóÿÿÿgHÿÿïÿÿÿÿþÿÿÿýÿ ÿÿÿÿøÿÿÿþÿÿÿÿÿÿÿþÿÿþ ÿÿÿÿþÿ ÿÿÿÿýÿÿÿÿÿÿÿþ ÿÿÿÿÿÅÿgHgHgHåÿÿÿþÿgHgHgHñÿÿ÷ÿÿÿîÿÿÿ÷ÿÿÿåÿÿÿëÿÿøÿ ÿÿÿÿÔÿgHgHgH‚ÿ‡ÿgHgH‚ÿ‚ÿ ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¾ÿgHgHìÿgHgHæÿÿÿ÷ÿÿÿöÿÿÿgHÿÿòÿÿþÿÿÿÿþÿÿýÿÿÿÿõÿÿÿþÿÿÿÿÿÿÿþÿ1ÿÿÿÿÿgHgHÿÿÿÿÿÿÿÿÿÿþ ÿÿÿgHgH¿ÿgHåÿÿÿþÿgHgHgHñÿÿ÷ÿÿÿîÿÿÿþÿgHgHÿÿÿåÿÿÿëÿÿøÿ ÿÿÿÿ‚ÿäÿgHgHòÿgHgHgHŒÿgHgH‚ÿ‚ÿ ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿŸÿgHgH‚ÿêÿÿÿüÿÿýÿÿöÿÿÿýÿÿÿûÿÿÿÿþÿÿÿÿÿgHgHýÿÿÿõÿÿÿÿþÿÿÿÿÿÿþÿÿÿÿÿÿûÿÿÿÿÿÿÿÿÿÿÿþ ÿÿÿgHgH ÿÿÿåÿÿ÷ÿÿÿîÿÿÿþÿgHgHÿÿÿåÿ ÿgHgHîÿÿÿûÿ ÿÿÿÿ‚ÿäÿgHgHòÿgHgHgHŒÿgHgH‚ÿ‚ÿ ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿŸÿgHgH‚ÿðÿ ÿÿÿÿüÿÿýÿÿöÿÿÿýÿÿÿøÿÿþÿÿÿÿÿÿgHgHýÿÿÿõÿÿÿÿþÿÿÿÿÿÿþÿÿúÿÿûÿ ÿÿÿÿÿþ ÿÿÿÿÿþÿýÿgHgH ÿ ÿÿÿÿëÿÿ÷ÿÿÿîÿÿÿþÿgHgHÿÿÿèÿ ÿÿgHgHîÿÿÿûÿ ÿÿÿÿ‚ÿäÿgHgHòÿgHgHgHŒÿgHgH‚ÿ‚ÿ ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿŸÿgHgH‚ÿðÿ ÿÿÿùÿÿÿýÿúÿ ÿÿÿÿýÿÿÿõÿÿÿÿÿÿþÿgHgHýÿÿÿòÿÿÿÿþ ÿÿÿÿÿéÿ ÿÿÿÿÿþÿÿÿÿþÿÿýÿgHgHgH£ÿ ÿÿÿÿëÿÿ÷ÿÿÿîÿøÿgHgHÿÿÿèÿ ÿÿgHgHîÿÿÿûÿ ÿÿÿÿ‚ÿ‚ÿÐÿgHgH‚ÿ‚ÿ ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿºÿgHgHgH‚ÿÛÿÿÿóÿÿÿýÿýÿ ÿÿÿÿúÿÿÿõÿÿÿÿÿÿþÿgHgHýÿÿÿòÿÿÿÿÿÿÿÿÿæÿÿÿÿþÿþÿÿÿÿþÿÿÿÿgHgHgH ÿ ÿÿÿëÿÿÿúÿÿÿãÿgHgHÿÿÿÇÿÿÿûÿÿÿÿÿÿÿÿ‚ÿ‚ÿèÿgHgHgHûÿgH‚ÿ‚ÿÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿºÿgHgHgH‚ÿÛÿÿÿÿÿÿúÿÿþÿþÿÿÿÿÿÿÿòÿÿÿþÿÿÿÿÿÿÿþÿgHgHýÿÿÿ÷ÿÿþ ÿÿÿÿúÿÿæÿ ÿÿÿÿÿýÿÿÿÿÿÿÿgHgHgH ÿÿÿèÿÿÿúÿÿÿãÿgHgHÿÿÿÇÿÿÿúÿýÿÿÿÿÿÿ‚ÿ‚ÿèÿgHgHgH‚ÿ‚ÿ”ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿºÿgHgHgH‚ÿÛÿÿÿÿÿÿ÷ÿþÿþÿÿÿÿÿÿÿòÿÿÿÿþ ÿÿÿÿÿûÿgHgHýÿÿÿ÷ÿÿþ ÿÿÿÿúÿÿßÿÿÿýÿÿÿÿÿÿÿgHgHgHÿÿèÿÿÿúÿÿÿãÿ gHgHÿÿÄÿÿÿúÿýÿÿÿÿÿÿÿûÿgHgHgH‚ÿ‚ÿúÿgHgHgH‚ÿ‚ÿ”ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‹ÿÿÿÿÿÿ÷ÿÿþÿþÿÿÿÿÿÿÿgHgHûÿÿýÿÿÿÿÿÿûÿgHgHúÿÿ÷ÿÿþÿÿÿÿúÿÿÿâÿÿÿýÿÿÿÿÿÿÿÿgHgHÈÿgHgHÑÿgHgHôÿÿÿúÿÿàÿgHgH¾ÿÿÿúÿýÿÿÿÿÿÿÿûÿgHgHgHìÿgHgH‚ÿ‚ÿ”ÿgHgH‚ÿ“ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÁÿgHgHgHìÿgHgHgHøÿÿÿþÿÿÿñÿÿþ ÿÿÿÿþ&ÿÿÿÿgHgHgHÿÿÿÿÿÿôÿgHgHúÿÿ÷ÿÿîÿÿÿòÿgHgHgHúÿÿÿýÿÿÿÿÿÿÿgHgHgHÈÿgHgHÔÿgHgHgHñÿÿúÿÿàÿgHgH¾ÿÿÿúÿÿýÿÿÿÿÿÿõÿgHìÿgHgH‚ÿ‚ÿ—ÿgHgHgH‚ÿ“ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÁÿgHgHgHñÿ ÿÿgHgHøÿÿÿþÿÿÿñÿÿþ ÿÿÿÿþÿÿÿÿgHgHþÿÿÿÿÿÿñÿgHgHúÿÿ÷ÿÿîÿÿÿòÿgHgHgHïÿÿÿÿÿÿÿgHgHgHÈÿgHgHÔÿgHgHgHñÿÿýÿÿÿàÿgHgH¾ÿÿÿýÿÿÿýÿÿÿÿÿÿÝÿgHgHžÿgHgHgHïÿgHgH‚ÿœÿgHgHgH‚ÿ“ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ¤ÿgHgHgH†ÿgHgHgH­ÿgHgHgHôÿ ÿÿÿgHõÿÿþ ÿÿÿÿñÿÿÿþÿÿþÿ ÿÿÿÿûÿ ÿÿÿÿþÿÿñÿgHgHúÿÿ÷ÿÿîÿÿÿúÿÿÿÝÿÿÿÿþÿgHgHËÿgHgHgH»ÿÿÿÿÿÿèÿ ÿÿgHgHÚÿgHgHgHëÿÿýÿÿÿýÿÿÿÿÿÿÝÿgHgHžÿgHgHgHïÿgHgH‚ÿœÿgHgHgH‚ÿ“ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿªÿgHþÿgHgHgH†ÿgHgHgH­ÿgHgHgHôÿ ÿÿÿòÿÿþ ÿÿÿÿñÿÿÿõÿÿ÷ÿ ÿÿÿÿÜÿÿ÷ÿÿßÿÿÙÿÿÿþÿgHgHËÿgHgHgH»ÿÿÿÿÿÿèÿ ÿÿgHgHÚÿgHgHgHëÿÿýÿÿÿþÿÿÿÿÿÿÝÿgHgHžÿgHgHgHïÿgHgHŒÿgHgHgH›ÿgHgH‚ÿÿû‚ÿíÿø‚ÿ‚ÿ‚ÿªÿgHgHgHgHgH†ÿgHgHgH­ÿgHgHgHôÿ ÿÿÿòÿÿþ ÿÿÿÿñÿÿÿõÿÿÿúÿ ÿÿÿÿÜÿÿúÿÿÿßÿÿÙÿÿÿÂÿgHgHgH»ÿÿÿßÿÿÿÔÿgHgHgHëÿÿÿÿÿÿþÿÿÿÿÿÿÝÿgHgHgH†ÿgHgHgHÿgHgHgH›ÿgHgH‚ÿÿû‚ÿíÿø‚ÿ‚ÿ‚ÿªÿgHgHgHgHgH¡ÿgHgHìÿgHgHgH­ÿgHgHñÿÿÿòÿÿÿþ ÿÿÿÿñÿÿÿõÿÿÿúÿ ÿÿÿÿÜÿÿÿýÿÿÿßÿÿÙÿÿÿÂÿgHgHgH»ÿÿÿßÿÿÿýÿÿÿàÿgHgHgHâÿÿÿþÿÿÿÿÿÿÝÿgHgHgH†ÿgHgHgH¡ÿgHgHgHøÿgHgHgH›ÿgHgH‚ÿÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ¤ÿgHgHgH¡ÿgHgHîÿ ÿgHgH­ÿgHgHñÿÿÿòÿÿþ ÿÿÿÿÿîÿÿõÿÿÿúÿÿÿÿôÿÿëÿÿÿýÿÿÿßÿÿÙÿÿÿÂÿgHgHgH‘ÿÿÿýÿÿÚÿgHgHâÿÿûÿÿÿÿÿÿÝÿgHgHgH†ÿgHgHgH¡ÿgHgHgH‰ÿgHgH‚ÿÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ¤ÿgHgHgH¡ÿgHgHñÿ ÿÿgHgH­ÿgHgHñÿÿïÿÿþ ÿÿÿÿÿîÿÿõÿÿÿýÿ ÿÿÿÿôÿÿëÿÿÿýÿÿÿâÿÿÿèÿôÿÿ¿ÿgHgHgHŽÿÿýÿÿÚÿgHgHåÿÿÿøÿ ÿÿÿÿûÿgHgHéÿgHgHgH†ÿgHgHgH¡ÿgHgHgH‰ÿgHgHgHgHgH‚ÿ™ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ¡ÿgHgH‹ÿ ÿÿÿgH­ÿgHgHñÿÿïÿÿþ ÿÿÿÿÿîÿÿ÷ÿýÿÿýÿ ÿÿÿÿôÿÿßÿÿßÿÿÿëÿÿÿ÷ÿÿ¿ÿgHgHgHŽÿ ÿÿÿÿÚÿgHgHßÿøÿ ÿÿÿÿûÿgHgHéÿgHgHgH†ÿgHgHgH‚ÿ¢ÿgHgHgHgHgHgH‚ÿ™ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ¡ÿgHgH‹ÿ ÿÿÿgH­ÿgHgHôÿÿÿûÿgHgHgHþÿÿþ ÿÿÿÿëÿ÷ÿÿÿýÿÿÿÿÿÿÿôÿÿòÿgHôÿÿÿåÿ ÿÿÿÿþÿgHgHôÿÿÿúÿÿÿ¿ÿgHgHgHÔÿgHgHgHÄÿ ÿÿÿÿÚÿgHgHgHÚÿÿþ ÿÿÿÿûÿgHgHéÿgHgHgH†ÿgHgHgH‚ÿ¢ÿgHgHgHgHgHgH‚ÿ™ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ¡ÿgHgHgHŽÿ ÿÿÿgH­ÿgHgHôÿÿÿûÿgHgHgHþÿÿþ ÿÿÿÿßÿÿÿýÿÿÿÿÿÿÿ÷ÿÿÿøÿgHgHgHôÿÿÿèÿ ÿÿÿÿþÿgHgHgHôÿÿÿúÿÿÿûÿgHgHËÿgHgHgHÑÿgHgHÁÿÿÿ×ÿgHgHgHÚÿÿþ ÿÿÿÿûÿgHgH‚ÿÿÿgHgHìÿgHgHgH‚ÿ¢ÿgHgHgH‚ÿÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ¡ÿgHgHgH‘ÿÿÿÿÿgHšÿÿÿýÿ ÿgHgHþÿÿþ ÿÿÿÿßÿÿÿýÿÿÿÿÿÿÿ÷ÿÿÿõÿgHgHôÿÿÿåÿ ÿÿÿèÿÿÿúÿÿÿûÿgHgHgH•ÿgHgHÁÿÿÿ×ÿgHgHgHÚÿÿþ ÿÿÿÿþÿgHgHgH‚ÿÿÿgHgHìÿgHgHgH‚ÿŸÿgHgH‚ÿÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ¡ÿgHgHgH‘ÿÿÿþÿgHgHšÿÿÿýÿÿgHgHÿÿþÿÿÛÿÿÿýÿÿÿÿÿÿÿÿúÿÿÿâÿÿÿåÿ ÿÿÿåÿÿ÷ÿÿûÿgHgHgH•ÿgHgHÂÿgHÿÔÿgHgHgH×ÿÿÿúÿgHgHgH‚ÿÿÿgHgHìÿgHgHgHŒÿgHgH‚ÿ‚ÿ£ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ­ÿgHgHgHþÿgHgHgH‘ÿÿÿþÿgHgHèÿÿÿ»ÿÿÿýÿ ÿÿgHÿþÿÿØÿÿûÿÿÿÿÿÿÿÿúÿÿÿâÿÿâÿ ÿÿÿåÿÿ‚ÿöÿgHgHgH’ÿgHgHgHÔÿÿúÿgHgHgH‚ÿÿÿgHgH‚ÿíÿgHgH‚ÿ‚ÿ£ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ­ÿgHgHgH©ÿÿÿåÿÿÿâÿ ÿÿÿ»ÿÿÿýÿ ÿÿgHÿþÿÿÛÿÿÿûÿgHgHgHýÿÿÿúÿÿÿ»ÿÿâÿÿ‚ÿöÿgHgHgH‚ÿÛÿÿúÿgHgHgH‚ÿÿÿgHgHƒÿgHgHgHõÿgHgH‚ÿ‚ÿ£ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿËÿÿÿûÿgHgHgHôÿÿÿâÿ ÿÿÿ¯ÿ ÿÿgHÿþÿÿÛÿÿÿûÿgHgHgHýÿÿÿúÿÿ”ÿÿ‚ÿöÿgHgHgH‚ÿÛÿÿÿýÿgHgHgHƒÿgHgHgHôÿÿÿ˜ÿgHgHgH‚ÿ‚ÿ‘ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿÎÿ ÿÿÿûÿgHgHgHôÿÿÿâÿ ÿÿÿ¯ÿÿýÿÿÿþÿÿáÿ ÿÿÿÿûÿgHgHgHýÿÿÿúÿÿ”ÿÿÿ‚ÿùÿgHgHgH‚ÿÛÿÿÿýÿgHgHgHƒÿgHgHgHôÿÿÿ˜ÿgHgHgH‚ÿüÿgH‚ÿ™ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿÎÿ ÿÿÿÿþÿgHgHgHôÿÿÿâÿ ÿÿÿÿ²ÿýÿÿÿÿÿÿáÿ ÿÿÿÿûÿgHgHgHýÿÿÿýÿÿÿ”ÿÿÿ¶ÿgHgHgHÎÿgHgHgH‚ÿÛÿÿÿýÿgHgHgHæÿgHgHgH§ÿgHgHgHñÿÿÿ›ÿgHgHgH‚ÿÿÿgHgH‚ÿ™ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿÎÿ ÿÿÿÿþÿgHgHgHôÿÿûÿÿÿîÿÿÿÿÿÿÔÿgHgHgHòÿÿÿÿþÿÿÿÿÿÿÿÿÿÿèÿ ÿÿÿÿûÿgHgHúÿÿÿýÿÿÿ­ÿgHgHgHñÿ ÿÿÿ¹ÿgHgHgHÎÿgHgHgH‚ÿÞÿÿÿþÿýÿgHgHgHæÿgHgHgH§ÿgHgHgHñÿÿÿ›ÿgHgH‰ÿgHgHûÿgHgH‚ÿ™ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿÎÿ ÿÿÿÿþÿgHgHgHìÿÿÿÿÿÿÿ÷ÿÿÿÿÿÿÔÿgHgHgHòÿÿÿÿþÿÿÿÿÿüÿÿÿåÿÿÿøÿgHgH÷ÿÿÿÿÿÿòÿgHgHgHÅÿgHgHgHîÿ ÿÿÿòÿgHgHgHÔÿgHgHgHËÿgHgH‚ÿÞÿÿÿþÿÿÿ‚ÿùÿgHgHgHñÿÿÿ›ÿgHgH‰ÿgHgH‚ÿÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ¡ÿgHgHgH¸ÿ ÿÿÿÿþÿgHgHéÿÿÿÿÿÿÿÿñÿÿÿåÿÿÝÿÿÿÿþ ÿÿÿÿ÷ÿÿÿâÿÜÿÿÿòÿgHgHgHÅÿgHgHgHîÿ ÿÿÿòÿgHgHgH‚ÿÕÿgHgHgHÑÿgHgHÔÿÿþÿÿÿ‚ÿùÿgHgHgHñÿ ÿÿgHgH¡ÿgHgH‰ÿgHgH‚ÿÿû‚ÿíÿø‚ÿ‚ÿ‚ÿžÿgHgH¯ÿÿþÿgHgHéÿÿÿÿÿÿÿÿîÿÿåÿÿÿãÿÿÿÿþ ÿÿÿÿÿ÷ÿÿ¸ÿÿÿ­ÿgHgHèÿÿÿòÿgHgHgH‚ÿÕÿgHgHgHÑÿgHgHÔÿÿþÿÿÿ‚ÿùÿgHgHgHñÿ ÿÿgHgH¡ÿgHgHòÿgHgHgH‚ÿ‚ÿ¦ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ­ÿgHgHøÿgHgH¯ÿÿþÿgHgHìÿÿÿÿÿÿÿÿÿîÿÿåÿÿÿåÿþÿÿÿþ ÿÿÿÿÿ÷ÿÿ‚ÿÛÿgHgH‚ÿ‚ÿâÿgHgHgH×ÿÿþÿÿ´ÿÿÙÿÿßÿÿÿžÿgHgHgHòÿgHgHgH‚ÿ‚ÿ¦ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ­ÿgHgH ÿÿþÿÿgHìÿÿÿÿÿÿÿÿÿÿÍÿÿÿèÿþÿÿÿþÿÿÿÿÿÿýÿÿÿ‚ÿÞÿgHgHgH‚ÿ‚ÿ¯ÿÿþÿÿ·ÿÿÿÜÿ ÿÿÿèÿÿýÿÿžÿgHgHgHòÿgHgHgH‚ÿ‚ÿ¦ÿû‚ÿíÿø‚ÿ‡ÿgHgHgH‚ÿ±ÿgHgH ÿÿþÿÿÿïÿÿþÿÿÿÿþÿÿÆÿÿÿéÿ ÿÿÿÿþÿÿÿþÿÿÿýÿÿÿ‚ÿÞÿgHgHgH‚ÿ‚ÿ¬ÿÿÿÿÿÿëÿÿÿÜÿ ÿÿÿßÿ ÿÿÿëÿÿÿýÿÿÿ¡ÿgHgHgHòÿgHgHgH‚ÿ‚ÿ¦ÿû‚ÿíÿø‚ÿ‡ÿgHgHgH‚ÿ´ÿgHgHgH ÿþÿÿÿÿòÿÿÿþÿÿÿÿþÿÿÿëÿÿÿåÿÿÿìÿÿÿÿÿÿÿÿÿþÿÿÿýÿÿÿ‚ÿÞÿgHgHgH‚ÿ‚ÿ¬ÿÿþ ÿÿÿÿÿîÿÿÿÜÿ ÿÿÿßÿ ÿÿÿëÿÿÿýÿÿÿ¡ÿgHgHgHòÿgHgHgH‚ÿ‚ÿ¦ÿû‚ÿíÿø‚ÿ‡ÿgHgHgH‚ÿ´ÿgHgHgH¡ÿÿÿÿÿÿôÿÿýÿÿÿÿÿÿþÿÿÿñÿÿÿÿåÿÿÿïÿÿÿÿÿÿÿÿüÿÿúÿÿÿ‚ÿÞÿgHgHgHžÿgHgHgH‚ÿ™ÿÿþ ÿÿÿÿÿñÿÿÿÿÿgHgHèÿ ÿÿÿÿßÿ ÿÿÿÿþÿ ÿÿÿüÿÿÿýÿÿÿ†ÿgHgH’ÿgHgH‚ÿœÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ°ÿgHgHgH¬ÿÿþÿÿÿÿÿÿÿôÿÿýÿÿÿÿÿÿþÿÿÿÿÿÿÿûÿÿþÿÿçÿÿÿþÿgHgHgHûÿÿÿÿÿÿÿúÿgHgHgHýÿÿÿÔÿgHgHgH•ÿgHgHgHžÿgHgHgHÈÿgHgHgH‚ÿØÿÿÿÿÿÿÿôÿÿÿÿÿgHgHèÿ ÿÿÿÿâÿ ÿÿÿÿþÿÿþÿÿÿüÿÿÿýÿÿÿ†ÿgHgH¤ÿgHgHgHøÿgHgH‚ÿœÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ°ÿgHgHgH¬ÿÿÿýÿÿÿÿÿÿôÿÿýÿÿüÿÿûÿÿÿÿÿÿþÿÿþÿÿÿçÿÿÿþÿgHgHgHûÿ ÿÿÿÿþÿ÷ÿgHgHgHýÿÿÿÔÿgHgHgHÔÿgHgHgHËÿgHgHgHÎÿgHgH×ÿgHgHgHÈÿgHgHgH‚ÿØÿÿÿÿÿÿÿôÿÿÿÿÿgHåÿÿÿÿÿÿåÿÿÿûÿÿþ ÿÿÿÿüÿÿúÿÿÿ†ÿgHgH¤ÿgHgHõÿgHgH‚ÿœÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ°ÿgHgHgHøÿgHgHgH¾ÿÿýÿÿÿÿÿÿÿôÿÿýÿÿüÿÿÿûÿ ÿÿÿÿþÿÿþ ÿÿÿÿóÿÿÿýÿÿïÿ ÿÿÿÿòÿgHgHgHýÿÿ›ÿgHgHgHÈÿgHËÿgHgHgH‚ÿÛÿgHgHgHËÿgHgHÐÿý ÿÿÿÿÿôÿ ÿÿÿÿâÿÿýÿÿÿåÿÿÿøÿÿÿÿÿÿÿÿÿúÿ ÿÿgHgHŒÿgHgHgH§ÿgHgHõÿgHgH‚ÿœÿû‚ÿíÿø‚ÿ‚ÿ ÿgHgHgH‚ÿºÿgHgHgHøÿgHgHgH¾ÿÿýÿÿÿÿÿÿÿÿúÿÿÿýÿÿüÿÿÿûÿÿÿýÿÿÿþ ÿÿÿÿóÿÿúÿÿÿõÿÿÿÿÿÿèÿÿÿ›ÿgHgHgHÿgHgHgH‚ÿÛÿgHgHgHËÿgHgHÎÿ ÿÿÿÿóÿ ÿÿÿÿâÿÿýÿÿâÿÿÿøÿÿÿÿÿÿÿÿÿþÿÿÿÿÿgHgHŒÿgHgHgH•ÿgHgH‚ÿœÿû‚ÿíÿø‚ÿ‚ÿýÿgHgH‚ÿºÿgHgHgHõÿgHgH¾ÿÿýÿÿýÿÿÿÿÿÿÿÿÿýÿÿùÿÿÿþÿÿþÿÿýÿÿþÿÿÿÿýÿÿöÿÿúÿÿÿõÿÿÿÿÿÿèÿÿÿ›ÿgHgHgHÿgHgHgH‚ÿÛÿgHgHgHËÿgHgHÍÿý ÿÿÿÿöÿÿÜÿÿÿÙÿÿõÿ ÿÿÿÿþÿÿÿÿþ ÿÿÿÿƒÿgHgHgH•ÿgHgH‚ÿœÿû‚ÿíÿø‚ÿ‚ÿýÿgHgH‚ÿºÿgHgHgH¬ÿÿýÿüÿýÿÿÿÿÿÿÿÿþÿÿùÿÿÿûÿÿþÿÿÿÿþÿÿÿÿýÿÿÿÿÿÿÿÿúÿÿÿõÿÿÿÿÿÿèÿÿÿ›ÿgHgHgHÿgHgHgH‚ÿÛÿgHgHŽÿÿÿýÿÿÿüÿÿÿ¬ÿÿõÿÿýÿÿþÿÿÿÿþ ÿÿÿÿÜÿÿÈÿgHgHìÿgHgHgH•ÿgHgH‚ÿœÿû‚ÿíÿø‚ÿŠÿgHgHgHþÿgHgHgH‚ÿ‚ÿáÿÿýÿÿüÿÿÿýÿÿÿÿÿÿþÿÿùÿÿÿúÿýÿÿÿÿÿÿÿÿýÿÿÿÿÿÿÿÿúÿÿÿûÿÿþÿÿÿÿÿÿèÿÿ˜ÿgHgHgHÿgHgHgH‚ÿÛÿgHgHŽÿÿÿþÿÿÿüÿÿÿ¬ÿÿøÿÿÿýÿÿþÿÿÿÿÿÿÿÞÿÿÿÈÿgHgHgH‚ÿùÿgHgHgH‚ÿŸÿû‚ÿíÿø‚ÿŠÿgHgHgHþÿgHgHgH‚ÿ‚ÿáÿÿýÿÿüÿÿÿþÿÿþÿÿÿÿÿÿùÿÿÿúÿýÿÿÿÿÿÿÿÿÿýÿÿÿÿÿÿÿ÷ÿÿûÿÿÿþ ÿÿÿÿÿëÿÿÿ˜ÿgHgHgHÿgHgHgH‚ÿÞÿgHgHgHŽÿÿÿþÿÿÿüÿÿÿ¬ÿÿúÿýÿÿúÿÿþÿÿÿÿÿÿÞÿÿÿÈÿgHgH‚ÿöÿgHgHgH‚ÿŸÿû‚ÿíÿø‚ÿŠÿgHgHgHþÿgHgHgH‚ÿ‚ÿáÿÿýÿÿüÿÿÿþÿÿÿþ ÿÿÿÿçÿÿýÿÿÿÿÿÿÿÿþÿÿÿÿþÿÿöÿÿþÿÿÿþ ÿÿÿÿÿ‚ÿóÿgHgHŒÿgHgHÝÿgHgH‰ÿgHgHgHÿgHgHûÿÿÿëÿgHgHgH²ÿýÿÿúÿÿþÿÿÿÿÿÿÞÿÿÿ‚ÿ·ÿgHgHgH’ÿgH’ÿû‚ÿíÿø‚ÿ‚ÿýÿgHgHgH‚ÿ‚ÿáÿÿýÿÿüÿÿÿþÿÿÿþÿ ÿÿÿçÿÿýÿÿÿüÿÿÿøÿÿÿýÿÿÿúÿ ÿgHgHÿþ ÿÿÿÿÿéÿgHgHÎÿgHgHgHÎÿgHgHgHÑÿgHgHgHÈÿgHgHgHàÿgHgHgH¿ÿgHgHÔÿgHgHgHÿgHgHøÿÿÿúÿÿÿÿþÿgHgHgHãÿÿÿÿÚÿÿþÿ÷ÿ ÿÿÿÿûÿÿÿçÿÿýÿÿ‚ÿÌÿgHgHgHõÿgHgHgH•ÿgHgHgH•ÿû‚ÿíÿø‚ÿ‚ÿýÿgHgHgH‚ÿ‚ÿáÿý ÿÿÿÿúÿÿþÿÿÿýÿýÿäÿÿñÿÿÿôÿýÿÿôÿgHgHþÿÿÿÿÿÿìÿgHgHgHÎÿgHgHgHÎÿgHgHgHÑÿgHgHÅÿgHgHgHàÿgHgH¼ÿgHgHgH×ÿgHgHgHƒÿÿþÿÿýÿÿÿÿÿÿÿÿgHéÿÿÿÿÿÿÿÝÿÿÿóÿþÿøÿÿÿçÿÿýÿÿÿ‚ÿÏÿgHgHgH‚ÿ ÿÿgHgHgH•ÿû‚ÿíÿø‚ÿ‚ÿýÿgHgHgH‚ÿ¥ÿgHgHÄÿý ÿÿÿÿúÿÿÿþ ÿÿÿÿÿåÿÿÿîÿÿôÿý ÿÿÿÿûÿgHgHgHþÿÿâÿgHgHgH’ÿgHgHgHÎÿgHÅÿgHgHgHàÿgHgH‰ÿgHgHgHÅÿgHgHgHÅÿÿÿýÿÿþÿÿÿÿÿÿgHñÿÿýÿÿÿÿÿÿÿÝÿÿÿÿgHgHýÿÿÿøÿÿÿÿÿgHgHþÿÿÿýÿÿÿýÿÿÿµÿžÿgHgHgH‚ÿŠÿû‚ÿíÿø‚ÿ‚ÿýÿgHgHgH‚ÿ¨ÿgHgHgHÅÿÿþÿÿöÿÿÿþ ÿÿÿÿÿïÿgHgHýÿÿÿîÿÿÿúÿÿý ÿÿÿÿûÿgHgHgHÿÿ‚ÿéÿgHgH‰ÿgHgHàÿgHgH‰ÿgHgHgHÅÿgHgHgHÂÿ ÿÿÿÿÿÿÿÿÿÿgHñÿýÿÿÿÿÿÿÿÿÿàÿÿÿÿÿgHìÿ&ÿÿÿÿgHgHÿÿÿÿÿÿÿýÿÿÿ¸ÿÿÿûÿgHªÿgHgHgH‚ÿŠÿû‚ÿíÿø‚ÿ‚ÿýÿgHgHgH‚ÿÀÿgHgHgHòÿgHgHgHÅÿÿþÿÿöÿÿÿúÿÿÿïÿgHgHýÿÿÿîÿÿÿúÿÿÿýÿÿÿþÿÿÿÿÿÿÿ‚ÿ‚ÿÆÿgHgHgH†ÿgHÂÿgHgHgHÂÿ ÿÿÿÿÿÿÿÿÿÿgHûÿÿÿýÿýÿÿÿÿÿÿÿÿÿæÿÿÿÿÿÿÿgHéÿ#ÿÿÿÿÿÿÿÿÿÿÿÿýÿÿÿ¸ÿÿÿþÿgHgHªÿgHgHgH‚ÿŠÿû‚ÿíÿø‚ÿ‚ÿúÿgHgH‚ÿÀÿgHgHgHòÿgHgHgHÈÿÿþÿÿóÿÿÿúÿÿÿïÿgHgHÿÿÿëÿÿÿúÿÿÿýÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿÃÿgHgHgH‚ÿÃÿgHgHgHÍÿÿøÿ"ÿÿÿÿÿÿÿÿÿgHgHÿþÿÿþÿ ÿÿÿÿÿþÿÿÿÿþÿÿÿùÿÿÿýÿÿÿÿÿÿÿæÿÿþÿÿÿÿÿÿÿÿÿÿ÷ÿÿÎÿgHñÿÿÿûÿgHgHªÿgHgH‚ÿ‡ÿû‚ÿíÿø‚ÿÿgHgHgH‚ÿ™ÿgHgHgHËÿÿþÿÿôÿ gHÿÿÿàÿ gHgHÿÿèÿÿÿúÿÿÿþÿÿÿÿÿÿgHgH‚ÿ‚ÿÀÿgHgH‚ÿÀÿgHgHgHÐÿÿÿ÷ÿÿøÿ+ÿÿÿÿgHÿÿÿÿÿÿÿÿÿÿþÿÿÿÿÿÿÿùÿÿýÿÿÿÿÿÿÿÿãÿ ÿÿÿýÿÿÿÿÿÿ÷ÿÿÎÿgHgHôÿÿÿžÿgHgH‚ÿ‡ÿû‚ÿíÿø‚ÿÿgHgHgH‚ÿ–ÿgHgHËÿÿþÿÿôÿ gHÿÿÿàÿgHgHgHåÿÿÿúÿÿÿþÿÿÿÿÿÿÿÿ‚ÿ‚ÿÁÿgHgHgH‚ÿ½ÿgHgH×ÿgHýÿÿÿ÷ÿÿøÿ ÿÿÿÿÿýÿÿÿÿÿÿÿÿÿÿþÿÿÿÿÿÿÿÿüÿÿý ÿÿÿÿÿýÿÿÿæÿÿþÿÿgHþÿÿÿÿÿÿþÿ ÿÿÿÿâÿÿÿõÿgHgHôÿÿÿžÿgHgH‚ÿ‡ÿû‚ÿíÿø‚ÿÿgHgHgH‚ÿ–ÿgHgHËÿÿÿñÿgHgHÿÿÿãÿgHgHgHâÿÿýÿÿÿûÿÿÿÿÿÿÿÿúÿÿ‚ÿ‚ÿÍÿgHgHgH‚ÿ½ÿgHgHgHÚÿgHgHýÿÿúÿÿÿõÿ)ÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿ ÿÿÿýÿÿÿüÿýÿÿÿÿÿÿýÿÿÿåÿ+ÿÿgHgHÿÿÿÿÿÿÿÿÿÿåÿ ÿÿÿâÿÿÿúÿßÿÿÑÿgHgHgHïÿgHgHgH’ÿgHgHgH›ÿû‚ÿíÿø‚ÿÿgHgHgH‚ÿ–ÿgHgHËÿÿÿêÿÿÿãÿgHgHgHâÿÿÿúÿøÿÿÿÿÿÿÿúÿÿÿàÿgHÔÿgHgH•ÿgHgHgHžÿgHgHgH¶ÿgHgHgH’ÿgHgHgHÝÿgHgHgHýÿÿÿýÿÿÿõÿÿÿÿÿÿúÿÿÿÿÿÿøÿÿÿÿûÿ ÿÿÿÿýÿÿÿÿÿÿýÿ ÿÿÿèÿ ÿÿgHgHþÿÿÿÿÿÿÿÿÿÿÿèÿ ÿÿÿÿåÿÿÿýÿÿÿëÿúÿÿÿÔÿgHgHgHïÿgHgHgHžÿgHgHgHþÿgHgHgH›ÿû‚ÿíÿø‚ÿÿgHgHgHþÿÿ‚ÿžÿgHgHÎÿÿÿäÿÿàÿgHgHÈÿÿÿÿÿÿÿúÿÿÿæÿgHgHgHÔÿgHgHÂÿgHgHÚÿgHgHgH¼ÿgHgHgHìÿgHgHgH³ÿgHgHàÿgH¶ÿgHgHgHÝÿgHgHgHýÿÿÿÿÿÿòÿÿþÿÿÿöÿÿÿñÿÿÿûÿÿÿÿÿÿÿÿÿÿ÷ÿ ÿÿÿèÿ ÿgHgHþÿÿÿÿÿÿÿÿÿÿÿèÿ ÿÿÿÿåÿÿÿýÿÿÿëÿÿÿÿÿÿÔÿgHgHgHƒÿgHgHgHþÿgHgH˜ÿû‚ÿíÿø‚ÿÿgHgHþÿ ÿÿÿêÿÑÿgH‚ÿíÿgHgHÎÿÿÿäÿÿàÿgHgHÅÿÿÿÿÿÿÿýÿÿÿæÿgHgHgHÔÿgHgHÂÿgHgH×ÿgHgH¼ÿgHgHgH•ÿgHgHgHãÿgHgHgH¼ÿgHgHgHÝÿgHgHgHúÿ ÿÿÿÿïÿÿþÿóÿÿÿîÿÿþÿÿÿþÿÿÿÿÿÿÿÿþÿgHgHÿÿÿÿèÿ ÿÿgHûÿ ÿÿÿÿÿþ ÿÿÿÿëÿÿÿýÿÿåÿÿþ ÿÿÿÿÿîÿÿÿýÿÿÿÔÿgHgHgHƒÿgHgHgHÿû‚ÿíÿø‚ÿÿgHgHþÿÿÿÿÿÿgHôÿýÜÿgHgHgHgHgHgH‚ÿðÿgHgHâÿïÿÿÿ¾ÿgHgH»ÿÿÿÿÿÿàÿgHgH×ÿgHgHgHÂÿgH†ÿgHgH•ÿgHgHgHãÿgHgH¹ÿgHgHgHÝÿgHgH÷ÿ ÿÿÿÿïÿÿÿÿôÿÿÿîÿÿþÿÿÿþ ÿÿÿÿôÿgHgHýÿÿåÿ ÿÿgHýÿÿþ ÿÿÿÿþ ÿÿÿÿëÿÿÿýÿÿèÿÿÿþ ÿÿÿÿÿîÿÿÿýÿÿÿ‚ÿÌÿgHgHgHÿû‚ÿíÿø‚ÿÿgHgHÿýÿÿÿÿÿgH÷ÿýÿÿÿâÿgHgHgHgHgHgHŒÿgHgH÷ÿÿÿÿgHgHgHëÿ ÿÿÿòÿÿÿÿ¿ÿgHgH»ÿÿÿÿÿÿàÿgHgHgHÚÿgHgHgH‚ÿ‚ÿÐÿgHgHgHàÿgH¶ÿgHgHgHàÿgHgHôÿÿÿéÿÿÿÿ÷ÿÿëÿÿþÿÿÿþÿÿÿñÿgHgHÜÿ ÿÿgHýÿÿÿþ ÿÿÿÿþ ÿÿÿÿÿñÿÿÿýÿÿèÿÿþÿþÿÿÿÿÿgHþÿÿÿÿÿÿÿÿýÿÿÿ‚ÿÌÿgHgHgHÿû‚ÿíÿø‚ÿÿgHgHÿÿÿÿÿÿgHøÿ ÿÿÿÿßÿgHgHƒÿgHgH÷ÿ ÿÿÿâÿ ÿÿÿõÿÿÿÿÿÿÂÿgHgHgH»ÿ ÿÿÿÝÿgHgHgHÚÿgHgHgH‚ÿ‚ÿÍÿgHgH‚ÿçÿgHgHÓÿÿÿ÷ÿÿëÿÿÿ÷ÿÿÿòÿgHgHÜÿÿÿúÿÿÿþÿÿÿþÿÿÿÿÿÿñÿÿúÿÿÿþÿgHñÿþÿþ*ÿÿÿÿÿÿgHÿÿÿÿÿÿÿÿúÿÿ‚ÿÌÿgHgHgHÿû‚ÿíÿø‚ÿÿ gHgHÿÿýÿÿôÿ ÿÿÿÿ‚ÿ×ÿgH÷ÿ ÿÿÿÿåÿ ÿÿÿÿøÿÿÿÿÿÿõÿgHgHgH…ÿÿÿÝÿgHgHgHÝÿgHgHgH‚ÿ‚ÿÊÿgHgHgH‚ÿíÿgHgHgHÓÿÿÿúÿÿÿëÿÿÿ÷ÿÿÿõÿgHgHgHÙÿÿúÿÿÿõÿÿÿýÿÿÿ÷ÿÿÿïÿgHgHgH÷ÿýÿÿÿÿÿÿÿÿýÿÿÿüÿÿÿúÿþÿÿ‚ÿÏÿgHgHgHÿû‚ÿíÿø‚ÿÿ gHgHÿÿýÿÿÿùÿý ÿÿÿÿ‚ÿÊÿÿÿßÿ ÿÿÿÿøÿÿÿÿÿÿõÿgHgHgH‚ÿÚÿgHgHgHÝÿgHgHgH‚ÿ±ÿgHgH¡ÿgHgHgH‚ÿíÿgHgHgHÐÿÿúÿÿÿëÿÿÿ÷ÿÿÿõÿgHgHgHÙÿÿÿúÿïÿÿÿÿÿÿÿýÿÿÿÿïÿgHgHgH÷ÿý*ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿÿÿßÿ‚ÿóÿgHgHgHÿû‚ÿíÿø‚ÿÿgHgHgHÿÿýÿÿÿúÿÿÿýÿÿÿ‚ÿÐÿÿÿßÿÿÿýÿÿûÿÿÿÿÿÿÿõÿgHgH‚ÿÕÿgHgHgHÝÿgHgHgH‚ÿ±ÿgHgHgH¡ÿgHgHgH‚ÿðÿgHgHÍÿÿgHýÿÿÿÜÿÿÿòÿgHgHgHÙÿÿÿæÿ#ÿÿÿÿÿÿÿÿÿÿÿÿòÿÿÿÿøÿ ÿÿÿýÿ ÿÿÿÿýÿ ÿÿÿÿýÿÿÿÿÿÿÿÿåÿÿÿàÿgHgHgH¡ÿgHgHøÿgHgHgHžÿû‚ÿíÿø‚ÿ‡ÿÿÿýÿÿÿúÿÿÿýÿÿÿ‚ÿÐÿÿÿßÿÿÿòÿÿÿÿÿÿòÿgHgHÿgHgHËÿgHgHgHàÿgHgHgH¶ÿgHæÿgHgHgH§ÿgHgHgHžÿgHgHgH‚ÿóÿgHgHgHËÿgHgHúÿÙÿÿÿòÿgHgHgH°ÿÿýÿ ÿÿÿÿÿþÿÿÿ÷ÿÿþÿÿÿÿÿÿÿúÿ ÿÿÿÿúÿ ÿÿÿÿÿÿÿÿÿÿÿåÿ ÿÿgHgHæÿgHgHgH¤ÿgHgHgHøÿgHgHgHžÿû‚ÿíÿø‚ÿŠÿÿÿ÷ÿÿúÿÿÿýÿÿÿ‚ÿÐÿÿþÿÿäÿÿïÿÿÿÿÿÿòÿgHgH’ÿgHgHgHËÿgHgHgHàÿgHgHgH¹ÿgHgHgHéÿgHgHgH‚ÿ·ÿgHgHòÿgHgH‚ÿÉÿgHgHÐÿÿïÿgHgH¯ÿÿûÿÿÿÿÿÿÿÿÿÿúÿgHÿÿÿÿÿÿÿ÷ÿÿÿÿøÿÿÿÿÿÿÿþ ÿÿÿÿÿåÿÿÿgHgHgHƒÿgHgHgHøÿgHgHgHžÿû‚ÿíÿø‚ÿŠÿÿÿ÷ÿÿÿÿÿÿúÿÿÿÖÿgHgH‚ÿÿýÿÿÿçÿÿòÿÿÿÿÿÿÿòÿgHgHÿgHgHËÿgHgHgHÿgHgHgHìÿgHgHgH‚ÿ¢ÿgHgHgH§ÿgHgHgH‚ÿøÿÿÿïÿgHgHÑÿgHgHåÿÿÿþÿÿþÿÿÿÿÿÿÿÿúÿÿÿýÿ ÿÿÿÿñÿÿõÿÿÿÿÿÿÿþ ÿÿÿÿÿñÿúÿÿÿgHgHgHëÿÿÿŒÿgHgHžÿû‚ÿíÿø‚ÿŠÿÿÿ÷ÿÿÿÿÿÿúÿÿþÿèÿgHgHgHûÿgHgHgHƒÿÿÿþÿÿÿÿgHgHgHñÿÿûÿÿÿÿÿÿÿÿÿÿõÿgHgHgHÑÿgHgHgHŒÿgH‰ÿgHæÿgHgHgH‚ÿŸÿgHgH§ÿgHgHgH‚ÿòÿïÿgHgHÑÿgHgHåÿÿÿþÿÿþÿÿÿÿÿÿÿþÿÿÿÿýÿÿáÿÿÿ÷ÿÿþ ÿÿÿÿþ ÿÿÿÿÿþóÿÿúÿÿâÿÿÿŒÿgHgHžÿû‚ÿíÿø‚ÿŠÿÿÿöÿý ÿÿÿÿ÷ÿÿÿëÿgHgHøÿgHgHgH’ÿgHgHúÿþÿþÿÿÿÿÿÿgHgHôÿÿÿþÿÿÿÿÿÿüÿÿÿõÿgHgHgHÑÿgHgHgH‚ÿ‚ÿôÿ gHgHgHgH‚ÿ‚ÿ»ÿgHgH‚ÿÞÿgHgHÑÿgHgHåÿÿÿþÿÿÿþÿÿýÿÿÿþÿÿÿÿÿÞÿÿÿúÿÿÿþÿÿÿûÿÿÿÿÿÿÿüÿÿÿúÿÿÿèÿÿÿÜÿ°ÿgHgHgH¡ÿû‚ÿíÿø‚ÿŠÿÿÿôÿ ÿÿÿôÿÿÿëÿgHgHõÿgHgH’ÿgHgHúÿþÿþÿÿýÿÿýÿÿÿÿþÿÿÿÿþÿþÿÿÿÿÿÿÿÿÿÿòÿgHgHgHÎÿgHgH‚ÿ‚ÿôÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ¶ÿÿÿ÷ÿÿÿþÿÿÿÿþ ÿÿÿÿÛÿÿúÿÿÿñÿýÿÿÿÿÿÿÿÿÿÿúÿÿÿèÿÿÜÿ ÿÿÿ¶ÿgHgHgH¡ÿû‚ÿíÿø‚ÿÿ gHgHÿÿñÿÿñÿÿÿëÿgHgHõÿgHgHgH˜ÿgHgHgHúÿýÿÿúÿ ÿÿÿÿÿþÿÿÿÿÿÿÿÿüÿÿÿÿÿÿòÿgHgH‚ÿ‚ÿ»ÿgHgHgH‚ÿ‚ÿ£ÿgHgH‚ÿ•ÿÿÿýÿÿÿøÿÿÿþÿÿÿÿÙÿgHgHýÿÿéÿÿÿþÿÿÿÿÿÿÿý ÿÿÿÿÿþÿÿÿôÿÿÿÜÿ ÿÿÿ¶ÿgHgHgH¡ÿû‚ÿíÿø‚ÿÿ gHgHÿÿÛÿýÿëÿgHgHõÿgHgHgH˜ÿgHgHgHúÿýÿÿúÿ%ÿÿÿÿÿÿÿÿÿÿÿÿùÿÿÿÿÿÿòÿgHgH‚ÿ‚ÿÁÿgHgHgHgHgH‚ÿ‚ÿ¦ÿ gHgHgHgH‚ÿ˜ÿÿÿýÿÿÿîÿÿÿ÷ÿÿéÿgHgHgHýÿÿàÿ ÿÿÿÿÿþ ÿÿÿÿÿÿþÿÿÿôÿÿÿßÿ ÿÿÿÿ¶ÿgHgHgH¡ÿû‚ÿíÿø‚ÿ“ÿ gHgHgHÿÖÿÿîÿgHgHgHõÿgHgHgH˜ÿgHgHgHûÿÿÿ÷ÿÿþÿÿÿÿÿÿÿþÿÿÿöÿ ÿÿÿÿïÿgHgH‚ÿ®ÿgHgH›ÿ gHgHgHgH‚ÿ‚ÿ ÿgHgH¼ÿgHgHgH‚ÿãÿÿÿýÿÿÿîÿÿÿúÿÿÿéÿgHgHgHÔÿ)ÿÿÿÿÿÿÿÿÿÿÿÿÿÿ÷ÿÿÿþÿgHgHgHòÿÿÿÿÿÿÿÿÿ¹ÿgHgHgH¡ÿû‚ÿíÿø‚ÿÿÿÿÖÿÿîÿgHgHgHõÿgHgHgH˜ÿgHgHgHþÿ ÿÿÿöÿýÿÿÿÿÿÿÿÿÿÿîÿÿ‚ÿùÿgHgHgH¼ÿgHgHgHõÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿÞÿgHgH‚ÿàÿ ÿÿÿÿèÿÿÿýÿÿÿæÿgHgHÑÿ ÿÿÿÿýÿÿÿÿÿÿÿÿüÿÿÿûÿgHgHgHøÿÿÿÿÿÿÿýÿÿÿÑÿgHgHgHòÿgHgHgH¡ÿû‚ÿíÿø‚ÿÿÿÿÖÿÿÿñÿgHgHgHõÿgHgHgH˜ÿgHgHûÿÿÿðÿýÿÿýÿ ÿÿÿÿ‚ÿÞÿgHgHgH¼ÿ gHgHgHgHõÿgHgH‚ÿ‚ÿ‚ÿ‚ÿÞÿgHgH‚ÿÝÿ ÿÿÿèÿÿÿýÿÿÿæÿgHgHgHÓÿýÿÿúÿÿþÿÿÿÿÿÿÿÿÿÿÿþÿ ÿÿÿÿøÿÿÿÿÿÿúÿÿÿÑÿgHgHgHïÿgHgH¡ÿû‚ÿíÿø‚ÿÿÿÿÖÿÿÿñÿgHgHòÿgHgHgH›ÿgHgHgHþÿÿÿíÿÿÿ‚ÿùÿgHÔÿgHgH¹ÿgH‚ÿ‚ÿ‚ÿ‚ÿ‡ÿgHgHgHÈÿgHgHgH»ÿ ÿÿÿÿãÿgHgHgHÖÿÿÿõÿÿÿþÿÿÿÿÿÿÿÿÿýÿÿÿÿÿÿûÿÿÿÿÿÿÿÿúÿÿ‚ÿÏÿû‚ÿíÿø‚ÿÿÿëÿgHgHïÿÿÿôÿgHgHgHïÿgHgH¯ÿïÿgHgHgHþÿÿÿíÿ ÿÿgHƒÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿˆÿgHgHgHÈÿgHgHgH»ÿ ÿÿÿÿãÿgHgHgHÜÿýÿÿÿõÿ ÿÿÿÿûÿÿþÿÿÿÿÿÿÿÿÿÿÿýÿÿÿÿÿÿÿÿúÿÿÿ‚ÿÒÿû‚ÿíÿø‚ÿÿÿëÿgHgHìÿÿôÿgHgHgHïÿgHgHgH²ÿÿòÿgHgHgHÿÿÿÿëÿÿÿýÿÿÿŒÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿˆÿgHgHÅÿgH²ÿÝÿgHgHgHâÿÿÿÿÿÿëÿÿÿûÿÿþ ÿÿÿÿýÿÿÿÿÿÿÿýÿÿÿÿÿÿÿÿÿÿ‚ÿÒÿû‚ÿíÿø‚ÿÿÿëÿgHgHgHïÿÿÿôÿgHgHšÿÿÿ÷ÿþÿgHgHgHÿÿÿÿëÿÿÿÿÿÿ‰ÿgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿüÿgHËÿgHgHgHâÿ ÿÿÿÿëÿõÿÿÿþÿÿ÷ÿ ÿÿÿÿôÿÿÿÿÿÿÿÿÿèÿÿÿ‚ÿöÿû‚ÿíÿø‚ÿ–ÿ gHgHÿÿëÿgHgHgHïÿÿÿ‡ÿÿÿþÿÿÿÿþÿÿÿþ ÿÿÿÿÿèÿ ÿÿÿÿÑÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ·ÿgHgHgH¦ÿÿÿ×ÿÿÿÿõÿ gHÿÿöÿûÿÿÿþÿÿÿÿÿÿîÿ ÿÿÿÿ‚ÿùÿû‚ÿíÿø‚ÿ–ÿ gHgHÿÿëÿgHgHgHïÿÿÿ‹ÿÿÿÿÿÿÿÿÿÿÿÿþ ÿÿÿÿÿèÿ ÿÿÿÑÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿòÿgH‚ÿÌÿgHgHgH‚ÿòÿÿÿîÿÿÿúÿÿÿþÿÿÿÿþ ÿÿÿÿëÿ ÿÿÿ‚ÿöÿû‚ÿíÿø‚ÿ–ÿ gHgHÿÿèÿgHgHgHïÿÿÿ‘ÿ/ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ§ÿgHgH˜ÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿåÿgHgHgH‚ÿÉÿgH‚ÿòÿÿÿïÿ gHÿÿÿýÿÿÿûÿÿÿÿþÿÿýÿÿÿùÿÿÿÔÿgHgHgH§ÿû‚ÿíÿø‚ÿÿÿåÿgHgHgHïÿÿÿöÿÿÿ§ÿ ÿÿÿÿÿýÿÿÿÿþÿÿÿÿÿÿÿÿ‚ÿºÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿåÿ gHgHgHgH‚ÿ‚ÿÓÿgHgHëÿìÿgHÿÿÿÿÿÿÿòÿ#ÿÿÿÿÿÿÿÿÿÿÿÿøÿgHgHgHæÿgHgHgHÜÿÜÿ ÿÿÿþÿû‚ÿíÿø‚ÿÿÿåÿgHgHgHìÿÿÿüÿ ÿÿÿÿ­ÿÿÿÿÿÿÿþÿ ÿÿÿÿþÿÿÿÿÿÿ‚ÿÌÿgHgHõÿ gHgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿâÿgHgHgHàÿgHgH°ÿgHgH‚ÿÒÿgHgHgHÐÿ ÿÿÿÿìÿÿÿÿÿÿÿÿÿÿÿõÿgHgHgHæÿgHgHÙÿÿÿâÿ ÿÿÿþÿû‚ÿíÿø‚ÿ“ÿÿÿåÿgHgHgHìÿÿÿÿÿÿÿÿÿîÿgHgHÈÿÿÿÿÿÿÿîÿÿÿÿÿÿÚÿgHgH‚ÿüÿgHgHgHgHgHgHgHgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿßÿ gHgHgHgHæÿgHgHgH°ÿgHgHgH‚ÿØÿgHgHgHÍÿ ÿÿÿÚÿÿþÿÿÿÿÿÿÿÕÿÿßÿÿÿåÿÿÿÿÿÿù‚ÿíÿø‚ÿ“ÿÿÿâÿgHgHgHïÿÿÿÿÿÿÿÿÿÿñÿgHgHËÿÿÿÿÿÿÿÿîÿ ÿÿÿÿÚÿgHgHgH‚ÿùÿgHgHgHgHgHgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÙÿ gHgHgHgHæÿgHgH°ÿgHgHgHÿgHgHÑÿgHgHgH˜ÿÿÿÿÿÿÿÿÿýÿÿÿÿèÿÿÿßÿ ÿÿÿèÿÿÿÿÿÿù‚ÿíÿø‚ÿ´ÿÿÿëÿÿÿßÿgHgHgHéÿÿÿÿÿÿÿÿÿôÿgHgHÎÿÿÿÿÿÿÿÿÿòÿgHgHÿÿÿÔÿgHgHgH‚ÿùÿgHgHgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÐÿgHgHgHgHgHgH•ÿgHgHgHàÿgH¹ÿgHgHgHÑÿgHgH”ÿÿýÿÿÿÿÿÿÿÿÿþ ÿÿÿÿüÿÿ÷ÿÿÿßÿÿþÿÜÿÿù‚ÿíÿø‚ÿ·ÿ ÿÿÿÿîÿÿÿßÿgHgHãÿgHgHøÿÿÿÉÿÿûÿ ÿÿÿüÿÿÿïÿgHgHËÿgHgHgHàÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÚÿ gHgHgHgH•ÿ gHgHgHgHæÿ gHgHgHgH¼ÿgHgHÔÿgHgHgH ÿÿÿÿÿÿÿøÿÿþÿÿÿÿÿÿÿÿÿÿÿþÿþÿÿÿÿÿÿþÿ ÿÿÿÿ÷ÿÿÿÿÿÿÿÿþ ÿÿÿÿÿûÿ ÿÿÿÿÿù‚ÿíÿø‚ÿ·ÿÿÿÿÿÿ÷ÿ gHgHÿÿ¬ÿ ÿÿÿÌÿÿÿýÿÿÿÿÿÿÿÿéÿgHÈÿgHgHgHæÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ×ÿgHgHgH’ÿgHgHgHgHgHéÿgHgH‰ÿgHgHgHÿÿÿÿÿÿõÿÿÿþÿÿÿÿÿÿþrÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿû‚ÿíÿø‚ÿ·ÿÿýÿÿÿ÷ÿ gHÿÿ¨ÿýÿÿÿÏÿÿýÿÿÿÿÿÿÿÿÿ­ÿ gHgHgHgHæÿgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÛÿgHgHgHgHgHìÿgH†ÿgHgHgHÂÿgHgHßÿ ÿÿÿèÿÿÿþÿÿÿþoÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿû‚ÿíÿø‚ÿºÿÿÿúÿÿÿúÿ gHÿÿ¥ÿýÿÿÿÿÿÿåÿÿþÿÿÿýÿÿÿ—ÿgHgHgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ½ÿgHgHgHgHgH‚ÿóÿgHgHgHÂÿgHgHgHÅÿgHgHýÿ ÿÿÿûÿÿþÿÿÿúÿgHÿÿÿÿÿûÿÿÿÿÿÿÿÿþÿÿÿÿÿÿÿÿþÿÿÿ÷ÿÿû‚ÿíÿø‚ÿ½ÿ ÿÿÿ÷ÿÿÿÿÿÿÿÇÿgHgHßÿýÿÿÿÿÿÿÿÿôÿÿþÿÿÿÿÿÿÿ‘ÿgHgHgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿºÿgHgHgHÿgHgHïÿgHgHgH¼ÿgHgHÈÿgHgHgHúÿÿÿÿÿÿÿïÿ gHÿÿÿúÿÿÿÿþÿÿÿ÷ÿÿÿþÿÿÿìÿgHû‚ÿíÿø‚ÿØÿ gHgHgHgHòÿÿÿôÿÿÿÿÿÿÄÿgHgHÜÿÿýÿÿÿÿÿÿÿÿÿþÿÿÿÿÿÿÿÿÿˆÿgHgHgH‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¾ÿgHgHgHòÿgHgHgH‚ÿ ÿÿgHgHgHgH÷ÿ ÿÿÿÿéÿgHÿÿÿÿÿÿÿëÿÿÿÿÿÿÿïÿgHû‚ÿíÿø‚ÿÕÿgHgHgHòÿÿÿîÿÿÿÄÿ gHgHgHgHÙÿÿøÿ ÿÿÿÿÿÿÿÿÿÿÿ×ÿgHÚÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿ‚ÿ‚ÿ¤ÿû‚ÿØÿgHgH‚ÿäÿgHgHgHÇÿ ÿÿÿÿåÿ ÿÿÿÿéÿû‚ÿíÿø‚ÿÕÿgHgHòÿÿÿëÿgHgHgHƒÿÿþÿÿÿÿÿÿÿÿÿÿ×ÿgHgHÝÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿ‚ÿ‚ÿ¤ÿû‚ÿÕÿgH‚ÿçÿ gHgHgHgHÄÿÿÙÿÿæÿû‚ÿíÿø‚ÿÀÿÿÿîÿgHgHgH‚ÿüÿgHÿþÿÿÿÿÿÿÿ×ÿgHgHgHÝÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿ‚ÿ‚ÿ¤ÿû‚ÿ‚ÿßÿgHgHæÿgHgHgHgHgH‚ÿóÿû‚ÿíÿø‚ÿÃÿÿÿîÿ gHgHgHgH‚ÿìÿÿÎÿgHÚÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿ‚ÿ‚ÿ¤ÿû‚ÿ‚ÿßÿgHgHgHòÿgHgHgHgHgHgH¶ÿgH¼ÿû‚ÿíÿø‚ÿÞÿÿîÿ ÿÿÿñÿ gHgHgHgH‚ÿ‡ÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿ‚ÿ‚ÿ¤ÿû‚ÿ‚ÿßÿgHgHìÿ gHgHgHgH³ÿ gHgHgHgHÚÿgHgHgHõÿû‚ÿíÿø‚ÿáÿ ÿÿÿÿ÷ÿ ÿÿÿëÿgHgH‚ÿáÿgHgHgHòÿgHgHgHÅÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿ‚ÿ‚ÿ¤ÿû‚ÿ‚ÿÄÿgHgH°ÿgHgHgHgHgHgHgHàÿgHgHgHõÿû‚ÿíÿø‚ÿçÿ,ÿÿÿÿÿÿÿÿÿÿÿÿÿgHgHïÿgH‚ÿáÿ#gHgHgHgHgHgHgHgHgHgHgHgHÅÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿ‚ÿ‚ÿ¤ÿû‚ÿ‚ÿ‚ÿæÿgHgHgHgHgHgHgHgHgHgHìÿgHgHõÿû‚ÿíÿø‚ÿêÿÿÿÿÿgHþÿÿÿÿÿÿÿÿgHgHgH‚ÿÉÿ gHgHgHgHgHgHgHgHgHgHgHÅÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿ‚ÿ‚ÿ¤ÿû‚ÿ‚ÿ‚ÿÝÿgHgHgHgHgHgHgHÚÿû‚ÿíÿø‚ÿíÿÿÿÿÿgH‚ÿ‚ÿÇÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿ‚ÿ‚ÿ¤ÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿíÿø‚ÿóÿÿÿÿÿÿgH‚ÿ‚ÿÄÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿ‚ÿ‚ÿ¤ÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿíÿø‚ÿüÿÿÿÿÿÿÿÿgH‚ÿ‚ÿÁÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿ‚ÿ‚ÿ¤ÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿíÿø§ÿ;ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿgH‚ÿ‚ÿ»ÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿ‚ÿ‚ÿ¤ÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿíÿ‚‚‚‚‚‚‚‚‚‚‚‚‚‚‚ã‚ÿíÿ‚‚‚‚‚‚‚‚‚‚‚‚‚‚‚ã‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿñÿõ‚ÿ‚ÿ‚ÿ¶ÿþãÿõ‚ÿ‚ÿ‚ÿÑÿòéÿò‚ÿ‚ÿ‚ÿÑÿõæÿõ‚ÿ‚ÿ‚ÿÅÿûìÿòŒÿûõÿþ‚ÿ‚ÿ‚ÿ¿ÿøéÿûõÿû‚ÿ‚ÿ‚ÿÚÿìïÿûøÿû‚ÿ‚ÿ‚ÿÚÿûûÿøïÿûõÿû‚ÿ‚ÿ‚ÿËÿûïÿûøÿûÿþòÿû‚ÿ‚ÿ‚ÿÈÿþûÿûéÿþòÿû‚ÿ‚ÿ‚ÿÝÿþòÿøõÿûòÿû‚ÿ‚ÿ‚ÿËÿûòÿûòÿþ‚ÿ‚ÿ‚ÿÎÿøòÿûòÿû•ÿûïÿû‚ÿ‚ÿ‚ÿÂÿûìÿûïÿû‚ÿ‚ÿ‚ÿãÿûïÿûõÿûòÿø‚ÿ‚ÿ‚ÿãÿþïÿûõÿûïÿû‚ÿ‚ÿ‚ÿÔÿþþÿûòÿûòÿø˜ÿûïÿû‚ÿ‚ÿ‚ÿÂÿûìÿûïÿû‚ÿ‚ÿ‚ÿãÿþìÿûøÿøòÿø‚ÿ‚ÿ‚ÿÎÿûõÿûïÿû‚ÿ‚ÿ‚ÿÔÿþþÿûòÿûòÿø›ÿøïÿû‚ÿ‚ÿ‚ÿÂÿûìÿûïÿû‚ÿ‚ÿ‚ÿËÿûøÿøòÿø‚ÿ‚ÿ‚ÿÎÿþòÿûïÿû‚ÿ‚ÿ‚ÿ×ÿþûÿûõÿøòÿø›ÿøïÿø‚ÿ‚ÿ‚ÿÅÿûïÿøïÿø‚ÿ‚ÿ‚ÿÎÿûøÿûìÿû‚ÿ‚ÿ‚ÿÑÿþòÿøïÿø‚ÿ‚ÿ‚ÿÝÿþøÿûõÿûìÿû›ÿøïÿø‚ÿ‚ÿ‚ÿÅÿûïÿøïÿø‚ÿ‚ÿ‚ÿÎÿþõÿûìÿû‚ÿ‚ÿ‚ÿÔÿøõÿøïÿø‚ÿ‚ÿ‚ÿàÿþõÿûõÿûìÿû›ÿøïÿø‚ÿ‚ÿ‚ÿÅÿûïÿøïÿø‚ÿ‚ÿ‚ÿÑÿûõÿûìÿû‚ÿ‚ÿ‚ÿÚÿïøÿøïÿø‚ÿ‚ÿ‚ÿãÿþòÿûõÿûìÿû›ÿøïÿø‚ÿ‚ÿ‚ÿÅÿûïÿøïÿø‚ÿ‚ÿ‚ÿÑÿþòÿûìÿû‚ÿ‚ÿ‚ÿÑÿøøÿøïÿø‚ÿ‚ÿ‚ÿãÿþòÿûõÿûìÿû›ÿøïÿø‚ÿ‚ÿ‚ÿÅÿûïÿøïÿø‚ÿ‚ÿ‚ÿÔÿþïÿûìÿû‚ÿ‚ÿ‚ÿÎÿøûÿøïÿø‚ÿ‚ÿ‚ÿæÿþïÿûõÿûìÿû›ÿøïÿû‚ÿ‚ÿ‚ÿÂÿûìÿûïÿû‚ÿ‚ÿ‚ÿÔÿþìÿûìÿû‚ÿ‚ÿ‚ÿËÿûøÿûïÿû‚ÿ‚ÿ‚ÿãÿàûÿûìÿû˜ÿûïÿû‚ÿ‚ÿ‚ÿÂÿûìÿûïÿû‚ÿ‚ÿ‚ÿ×ÿþéÿøòÿø‚ÿ‚ÿ‚ÿËÿûøÿûïÿû‚ÿ‚ÿ‚ÿãÿàøÿûòÿø˜ÿûïÿû‚ÿ‚ÿ‚ÿÂÿûìÿûïÿû‚ÿ‚ÿ‚ÿÚÿþæÿøòÿø‚ÿ‚ÿ‚ÿËÿþõÿûïÿû‚ÿ‚ÿ‚ÿÎÿûòÿûòÿø˜ÿûòÿû‚ÿ‚ÿ‚ÿ¿ÿûìÿûòÿû‚ÿ‚ÿ‚ÿÚÿþàÿûòÿû‚ÿ‚ÿ‚ÿÈÿþõÿøòÿþ‚ÿ‚ÿ‚ÿËÿûòÿûòÿû’ÿûõÿû‚ÿ‚ÿ‚ÿ¿ÿûéÿûõÿû‚ÿ‚ÿ‚ÿÚÿæõÿþòÿþ‚ÿ‚ÿ‚ÿÝÿûòÿþïÿûõÿû‚ÿ‚ÿ‚ÿËÿûïÿþòÿûÿûûÿû‚ÿ‚ÿ‚ÿ¿ÿõéÿûûÿû‚ÿ‚ÿ‚ÿÝÿãïÿûþÿû‚ÿ‚ÿ‚ÿÚÿõûÿþéÿûûÿû‚ÿ‚ÿ‚ÿÈÿûìÿûþÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÝÿéÎÿæéÿìûÿì‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿþÿø¹ÿòÝÿøæÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿþÿø¶ÿõÝÿûãÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿþÿø³ÿøÝÿûãÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿþÿø³ÿõàÿþàÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿøòÿõ¶ÿø³ÿõãÿûàÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿôÿøæÿø¹ÿø°ÿõæÿûàÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ÷ÿøãÿõ¼ÿøÝÿòãÿõæÿþÝÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿúÿøïÿþïÿø¿ÿøãÿûøÿøãÿõìÿûÝÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿýÿõòÿøòÿõÂÿøæÿþïÿøæÿõìÿûÝÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿýÿõòÿøòÿõÂÿøéÿûìÿøæÿøìÿþÚÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿýÿøïÿøïÿøÂÿøéÿûìÿøæÿõòÿûÚÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿýÿøïÿøïÿøÂÿøéÿÝãÿøõÿøÚÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿõïÿøïÿõÅÿøìÿûÂÿõøÿû×ÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿõïÿøïÿõÅÿøìÿøÂÿøøÿû×ÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿõïÿøïÿõÅÿøìÿøÂÿõþÿûÔÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿõïÿøïÿõÅÿøìÿøÂÿõþÿûÔÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿýÿøìÿþìÿøÂÿøìÿøãÿþàÿòÑÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿýÿøïÿøïÿøÂÿøìÿõéÿûàÿòÑÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿýÿõòÿøòÿõÂÿøéÿõïÿûÚÿõÑÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿúÿøõÿûþÿûõÿø¿ÿøéÿïøÿû×ÿøÎÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿúÿõûÿûøÿûþÿõ¼ÿøæÿæÔÿøÎÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿôÿòòÿò¹ÿøãÿìÎÿþËÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿþÿø‚ÿáÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿþÿø‚ÿáÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿþÿø‚ÿáÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿþÿø‚ÿáÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿþÿõ‚ÿçÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿËÿ€ endstream endobj 85 0 obj << /Type /XObject /Subtype /Image /Name /Ma0 /Filter [/RunLengthDecode] /Width 694 /Height 492 /ColorSpace /DeviceGray /BitsPerComponent 8 /Length 87 0 R >> stream ‚‚‚‚‚Æ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ€ endstream endobj 91 0 obj << /Length 2316 /Filter /FlateDecode >> stream xÚXÛŽÛ8}ï¯ð£ ÄŠHÝwŸ2“dЋE6“î‹Éä–è¶YrtI¦çë÷‹”%G½Û³h IÉb±êÔÍÁæal~¹ ®FÿÁFlD&ý,I7q˜ùcqºùzøa¤±Ù2Ÿ›EwÒ^Þž’ÍëöæWü¹¥ãº›±ýéþæå[0Jý< Äæþ°Aâ‡q¼‰Eæ§Ñæ¾Ü|òÞVc§·; /þÛv‰w{:wíVÄÞ7ú§OºxCÕð8Í ém³»¯ÛŠÌ{ÐMaÙµ‡Åná©}ßvç¡j>ÝŸu1tãi¹ý0Öµîtcý¼ý|ÿóIzˆL2?JèÝ>¦ü$˜6^^œùažof»Æ¾j®ÄÒ$ýC§Îm­.Ò º86Õ×QßÍN¦ T¼Ùå¸9ff¥î‹®Úëj¬ïtáó,ô%fQz÷t‘.o¦¯¢=ÇÁ1PBe9èΈÔÛÓCU×vzl·2ö¾Û•ïUiohû›æ§ªÃå6Õ¹Û†ÖŽN4sgÞð+-BÆ¥³ð:Ý5IH–´00Rs©éõIäÝxA°ÂSûFœ_¼1pò`òOÕ¶–Z´ÚÚ7›ÙW†¡$ä,FÔß‘¬  ñã\º=E8[¦ª³W-!À¯”¬!ÚÆC?®H'~†Ï@,¨™g­¬bda$ý$ ”5ãiOZ“qþq ,ÐìË aâç=ü}E†Ðå$ƒ114q8V=Ï Õk\#^¸méTékæºøÚk¬jË@Õ§¶û²f›‡±êj_[^‡®=ýÀþÇHbïb°ùô¦)œšÇåx³4a¾$ï ¥/¿·ó„8ëÊH—º¯Dî«Ó8¹ -p®êOŽXŸLÓñw1—«EŽÐ›ÎNÊ¿l2¡Ëíé™ßت&ÐÝþ:V&cE1íZ€ ˜›`™-„È3?‹„ðóØ"ˆp,³lUÇä¡Rz÷[bÊÛ=ƾ0qR‡ ¬ -œu7<ò—jx]•eE"¨Ú^£êbœ")6¸ Kg˜Ò´ ¼Dêu÷Í®§àï~&ü¹H4ȹ×cÙžÛT© S„ÀcU15P1j$÷ŽÙoAј˜FƒÓÔy M\{0ðÍ9ªêÚædœÀ¨7¨qx]M‹$3j™)*1~¼`Ü:±äaòU|ìÛÑÈ›Pñ9yçð4OHú«µ`:/°Ó ™ŠçqJhcNÔ:z»K™ýæîý‡7wwÿzÁw('Q5Ì Çðªpä>&e§²- üè‘©«1(ÊM4û íK;¦sâ)[X“Z¦Ë½ÐÏÀátTçÃÎØ ¿ôL^&/æj蜮Û­ª7‡¢øYêE7"ý8½òD§gê_Bæ¯Ü'Á4›‚Ã÷œÄĤΓúBÅ…é×À}¤)L%#˜üòî#¯(ôiCÛÖTp%iæ½²¿(aÏTLƒQÑÌOr861êÚÖDHX-O—ùªDóX m÷ÈaÃdÌù¯k:Nž=ÁÑ%B^Tkî@æ·¿¹P*²ÅÐìî 1þøøîößÓï2èÑʵ°¶AèG¹Ddƒ—ÙÀ濊ü«ïJ“྘*ë²<œ‡•W ~ÜÆRxE§Ío4Žz (hmå3’ÉOÛšœ‡N~Hêù2ðÓ÷eÂ4–ɾj^®Ü$úÉÈî9´uI€"ždýXZ aÍúIâç¡xžõc_¤?°ÅÏZ°E”ùA/a)âÅ®7÷7ÿ-sê endstream endobj 78 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (./figure3_new.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 92 0 R /BBox [0 0 694 492] /Resources << /XObject << /Im0 93 0 R >>/ProcSet [ /PDF /Text /ImageC ] >> /Length 31 >> stream q 694 0 0 492 0 0 cm /Im0 Do Q endstream endobj 93 0 obj << /Type /XObject /Subtype /Image /Name /Im0 /Filter [/RunLengthDecode] /Width 694 /Height 492 /ColorSpace 94 0 R /BitsPerComponent 8 /SMask 95 0 R /Length 96 0 R >> stream ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿ‚‚‚‚‚‚‚‚‚‚‚‚‚‚‚ã‚ÿíÿ‚‚‚‚‚‚‚‚‚‚‚‚‚‚‚ã‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿòÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿòÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿòÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿòÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿòÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿòÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿòÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿòÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿòÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿòÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿžÿ‚‚‚‚‚×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿžÿ‚‚‚‚‚×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿžÿû‚ÿ‚ÿ‚ÿ‚ÿÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿžÿû‚ÿ‚ÿ‚ÿ‚ÿÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿžÿû‚ÿ‚ÿ‚ÿ‚ÿÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿžÿû‚ÿ‚ÿ‚ÿ‚ÿÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿžÿû‚ÿ‚ÿ‚ÿ‚ÿÿø×ÿû‚ÿíÿø‚ÿÿþæÿøãÿøãÿø×ÿþ‚ÿçÿþ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÐÿû‚ÿ‚ÿ‚ÿ‚ÿÿø×ÿû‚ÿíÿø‚ÿ–ÿøéÿïïÿûøÿûïÿûøÿûàÿø‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÓÿû‚ÿ‚ÿ‚ÿ‚ÿÿø×ÿû‚ÿíÿø‚ÿ™ÿõìÿûûÿõòÿûõÿûõÿûõÿûàÿû‚ÿçÿþ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÐÿû‚ÿ‚ÿ‚ÿ‚ÿÿø×ÿû‚ÿíÿø‚ÿ–ÿøïÿþïÿûõÿûòÿûõÿûòÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿû‚ÿ‚ÿ‚ÿ‚ÿÿø×ÿû‚ÿíÿø‚ÿ–ÿøÚÿûõÿûïÿûûÿûïÿûËÿþ•ÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ»ÿû‚ÿ‚ÿ‚ÿ‚ÿÿø×ÿû‚ÿíÿø‚ÿ–ÿøÚÿûøÿøïÿûûÿûïÿøÑÿû•ÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ»ÿû‚ÿ‚ÿ‚ÿ‚ÿÿø×ÿû‚ÿíÿø‚ÿ–ÿøÚÿûøÿûìÿûûÿûìÿûãÿûøÿïõÿõïÿþûÿøøÿòõÿòõÿûïÿòïÿûûÿøïÿõ‚ÿ‚ÿ‚ÿ‚ÿºÿû‚ÿ‚ÿ‚ÿ‚ÿÿø×ÿû‚ÿíÿø‚ÿ–ÿøÚÿûøÿûìÿûûÿûìÿûéÿõõÿûòÿþõÿûûÿõþÿõûÿþõÿûõÿûõÿõõÿûõÿûõÿòþÿøõÿûøÿþ‚ÿ‚ÿ‚ÿ‚ÿ½ÿû‚ÿ‚ÿ‚ÿ‚ÿÿø×ÿû‚ÿíÿøÊÿ.ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿëÿ.ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÂÿøÚÿþõÿûìÿûûÿûìÿûæÿøõÿûõÿûòÿûøÿøòÿûõÿûõÿûïÿûøÿûïÿûõÿûõÿûõÿþ‚ÿ‚ÿ‚ÿ‚ÿ®ÿû‚ÿ‚ÿ‚ÿ‚ÿÿø×ÿû‚ÿíÿøÊÿ.ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿëÿ.ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÂÿøÝÿûõÿûìÿûûÿûìÿûæÿøõÿûõÿþïÿûøÿûìÿþõÿûõÿûïÿûøÿûïÿûõÿûõÿûõÿû‚ÿ‚ÿ‚ÿ‚ÿ±ÿû‚ÿ‚ÿ‚ÿ‚ÿÿø×ÿû‚ÿíÿø‚ÿ–ÿøàÿûòÿûìÿûûÿûìÿûæÿøõÿûõÿþàÿûàÿøõÿûïÿûøÿûìÿûøÿûõÿûõÿõ‚ÿ‚ÿ‚ÿ‚ÿ·ÿû‚ÿ‚ÿ‚ÿ‚ÿÿø×ÿû‚ÿíÿø‚ÿ–ÿøàÿþïÿûìÿûûÿûìÿûæÿøõÿûõÿþàÿûæÿûþÿûõÿûïÿûøÿûìÿûøÿûõÿûòÿõ‚ÿ‚ÿ‚ÿ‚ÿºÿû‚ÿ‚ÿ‚ÿ‚ÿÿø×ÿû‚ÿíÿø‚ÿ–ÿøãÿþìÿûìÿûûÿûìÿûæÿøõÿûõÿþàÿûìÿûøÿûõÿûïÿûøÿûìÿûøÿûõÿûïÿõ‚ÿ‚ÿ‚ÿ‚ÿ½ÿû‚ÿ‚ÿ‚ÿ‚ÿÿø×ÿû‚ÿíÿø‚ÿ–ÿøæÿþæÿûïÿûûÿûïÿûãÿøõÿûõÿûãÿûïÿûõÿûõÿûïÿûøÿûìÿþõÿûõÿûéÿø‚ÿ‚ÿ‚ÿ‚ÿÀÿû‚ÿ‚ÿ‚ÿ‚ÿÿø×ÿû‚ÿíÿø‚ÿ–ÿøéÿþìÿþûÿûòÿûõÿûòÿûãÿøõÿûõÿøæÿûïÿûõÿûõÿûïÿûøÿøòÿûõÿûõÿûõÿþõÿø‚ÿ‚ÿ‚ÿ‚ÿÃÿû‚ÿ‚ÿ‚ÿ‚ÿÿø×ÿû‚ÿíÿø‚ÿ–ÿøìÿþìÿþøÿûòÿûõÿûòÿûãÿøõÿûõÿøòÿþøÿûïÿûõÿûõÿûïÿûøÿøòÿûõÿûõÿûõÿþòÿû‚ÿ‚ÿ‚ÿ‚ÿÃÿû‚ÿ‚ÿ‚ÿ‚ÿÿø×ÿû‚ÿíÿø‚ÿ–ÿøïÿãõÿûõÿþïÿûøÿûàÿøõÿøþÿþûÿìõÿûïÿøûÿøõÿøþÿþøÿûõÿøõÿþòÿûõÿûõÿþõÿû‚ÿ‚ÿ‚ÿ‚ÿÀÿû‚ÿ‚ÿ‚ÿ‚ÿÿø×ÿû‚ÿíÿø‚ÿœÿìøÿãìÿõéÿõàÿïõÿøõÿòøÿìõÿøûÿøøÿõþÿìõÿòõÿòþÿïûÿï‚ÿ‚ÿ‚ÿ‚ÿ½ÿû‚ÿ‚ÿ‚ÿ‚ÿÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿžÿû‚ÿ‚ÿ‚ÿ‚ÿÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿžÿû‚ÿ‚ÿ‚ÿ‚ÿÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿžÿû‚ÿ‚ÿ‚ÿ‚ÿÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿžÿû‚ÿ‚ÿ‚ÿ‚ÿÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿžÿû‚ÿ‚ÿ‚ÿ‚ÿÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿžÿû‚ÿ‚ÿ‚ÿ‚ÿÿø×ÿû‚ÿíÿø‚ÿÿþæÿøãÿøãÿø×ÿþ‚ÿçÿþ‚ÿ‚ÿ‚ÿ§ÿþ‚ÿ®ÿû‚ÿ‚ÿ‚ÿ‚ÿÿø×ÿû‚ÿíÿø‚ÿ–ÿøéÿïïÿûøÿûïÿûøÿûàÿø‚ÿíÿø‚ÿ‚ÿ‚ÿþÿõ¼ÿû‚ÿ®ÿû‚ÿ‚ÿ‚ÿ‚ÿÿø×ÿû‚ÿíÿø‚ÿœÿþþÿøïÿûõÿøòÿûõÿûõÿûõÿûÝÿþ‚ÿçÿþ‚ÿ‚ÿ‚ÿõÿû¹ÿþ‚ÿ®ÿû‚ÿ‚ÿ‚ÿ‚ÿÿø×ÿû‚ÿíÿø‚ÿ–ÿøïÿþïÿûõÿûòÿûõÿûòÿûËÿþ’ÿþ‚ÿ‚ÿ‚ÿàÿûÎÿþ‚ÿ™ÿû‚ÿ‚ÿ‚ÿ‚ÿÿø×ÿû‚ÿíÿø‚ÿ–ÿøÚÿûõÿûïÿûûÿûïÿûÎÿû•ÿû‚ÿçÿûžÿþ‚ÿçÿûÑÿû‚ÿ™ÿû‚ÿ‚ÿóÿÿ‚ÿ‚ÿ£ÿø×ÿû‚ÿíÿø‚ÿ–ÿøÚÿûøÿøïÿûûÿûïÿøÑÿû•ÿû‚ÿçÿû¡ÿû‚ÿçÿûÑÿû‚ÿ™ÿû‚ÿ‚ÿóÿÿ‚ÿ‚ÿ£ÿø×ÿû‚ÿíÿø‚ÿ–ÿøÚÿûøÿûìÿûûÿûìÿûæÿøûÿìøÿþûÿøõÿûûÿøûÿûûÿûøÿïõÿûòÿûûÿûòÿøþÿõïÿþûÿûéÿûãÿþûÿûõÿõøÿûøÿïûÿøþÿøûÿûûÿûõÿøþÿòïÿûûÿûïÿûòÿûûÿûøÿïøÿûïÿûûÿûòÿøþÿõ‚ÿùÿû‚ÿ‚ÿóÿÿÿ‚ÿ‚ÿ¦ÿø×ÿû‚ÿíÿø‚ÿ–ÿøÚÿûøÿûìÿûûÿûìÿûìÿþþÿøõÿûòÿþõÿûõÿûþÿþþÿûûÿþõÿûõÿûøÿþþÿøõÿûõÿûòÿøøÿûõÿþõÿþéÿûéÿûõÿûõÿøøÿþòÿûòÿõþÿûûÿþõÿûõÿøøÿøõÿûõÿûòÿûõÿûõÿþòÿûøÿþþÿûòÿûõÿûòÿøøÿû‚ÿüÿû‚ÿ‚ÿ÷ÿ ÿÿÿÿ‚ÿ‚ÿ¦ÿø×ÿû‚ÿíÿø‚ÿ–ÿøÚÿþõÿûìÿûûÿûìÿûæÿøõÿûõÿþïÿûøÿøòÿûõÿûõÿûïÿûøÿûïÿûõÿûõÿûõÿþÚÿûéÿþòÿøõÿûûÿþïÿûòÿøòÿûõÿûõÿûòÿøûÿûïÿûõÿûõÿûõÿûõÿûòÿûõÿûïÿûõÿûõÿû‚ÿüÿû‚ÿ‚ÿ÷ÿ ÿÿÿ‚ÿ‚ÿ¥ÿø×ÿû‚ÿíÿø‚ÿ–ÿøÝÿûõÿûìÿûûÿûìÿûæÿøõÿûõÿþïÿûøÿûìÿþõÿûõÿûïÿûøÿûïÿûõÿûõÿûõÿûÝÿûéÿþòÿøõÿõìÿûòÿøïÿþõÿûõÿûòÿøûÿûïÿøøÿûõÿûõÿûõÿûòÿûõÿûïÿøøÿûõÿû‚ÿüÿû‚ÿ‚ÿúÿÿÿÿÿÿÿ‚ÿ‚ÿ©ÿø×ÿû‚ÿíÿøËÿÿÿìÿ ÿÿÿÿÿÿÿÿÿÿÿìÿÿÿÿïÿÿÿÿÿÿÿÿÎÿøàÿûòÿûìÿûûÿûìÿûæÿøõÿûõÿþàÿûàÿøõÿûïÿûøÿûìÿûøÿûõÿûõÿõòÿÚþÿûÚÿøìÿûòÿøãÿøõÿûïÿûûÿûìÿûøÿûæÿøõÿûòÿûõÿûìÿûøÿûõÿû‚ÿüÿû‚ÿ‚ÿúÿÿÿÿÿÿÿ‚ÿ‚ÿ©ÿø×ÿû‚ÿíÿøËÿÿÿìÿ ÿÿÿÿÿÿÿÿÿÿÿìÿÿÿÿïÿÿÿÿÿÿÿÿÎÿøàÿþïÿûìÿûûÿûìÿûæÿøõÿûõÿþàÿûéÿûûÿûõÿûïÿûøÿûìÿûøÿûõÿûòÿõõÿÚþÿû×ÿûìÿûòÿøìÿûûÿûõÿûïÿûûÿûìÿûøÿûïÿûûÿûõÿûòÿûõÿûìÿûøÿûõÿû‚ÿüÿû‚ÿ‚ÿúÿÿÿÿþÿÿÛÿÿÿ‚ÿ‚ÿÖÿø×ÿû‚ÿíÿøËÿÿÿìÿ ÿÿÿÿÿÿÿÿÿÿÿìÿÿÿÿïÿÿÿÿÿÿÿÿÎÿøãÿþìÿøïÿûûÿûïÿøæÿøõÿûõÿûãÿûìÿûøÿûõÿûïÿûøÿûìÿûøÿûõÿûìÿõìÿûìÿøÝÿþþÿûïÿûòÿøïÿûøÿûõÿûïÿûûÿûìÿûøÿûòÿþõÿûõÿûòÿûõÿûìÿûøÿûõÿû‚ÿüÿû‚ÿ‚ÿüÿýÿÿÿþ ÿÿÿÿæÿÿÿÿÿÿ‚ÿ‚ÿÖÿø×ÿû‚ÿíÿø‚ÿ–ÿøæÿþæÿûïÿûûÿûïÿûãÿøõÿûõÿûìÿþûÿûïÿûõÿûõÿûïÿûøÿûìÿþõÿûõÿûæÿøïÿûìÿøàÿþûÿøòÿûòÿøòÿûõÿûõÿûïÿûûÿûìÿûøÿûõÿûõÿûõÿûòÿûõÿûìÿûøÿûõÿû‚ÿüÿû‚ÿ‚ÿýÿÿÿýÿ ÿÿÿÿæÿ ÿÿÿ‚ÿ‚ÿÒÿø×ÿû‚ÿíÿø‚ÿ–ÿøéÿþìÿþûÿûòÿûõÿûòÿûãÿøõÿûõÿøæÿûïÿûõÿûõÿûïÿûøÿøòÿûõÿûõÿûõÿþõÿøïÿûéÿûïÿþõÿþøÿûòÿûòÿøòÿûõÿûõÿûòÿûøÿøòÿûõÿûõÿûõÿûõÿûòÿûõÿøòÿûõÿûõÿû‚ÿüÿû‚ÿ‚ÿýÿÿÿýÿ ÿÿÿÿæÿ ÿÿÿ‚ÿ‚ÿÒÿø×ÿû‚ÿíÿø‚ÿ–ÿøìÿþìÿþøÿøõÿûõÿûõÿûàÿøõÿûõÿõøÿûøÿûïÿûõÿûõÿûïÿûõÿûòÿûõÿûõÿûõÿþòÿûïÿûéÿøõÿþõÿþõÿøõÿûòÿøòÿûõÿûõÿûòÿûõÿûòÿûõÿûõÿûøÿøõÿûòÿûòÿûòÿûõÿûõÿû‚ÿüÿû‚ÿ‚ÿýÿÿÿýÿ ÿÿÿÿéÿÿÿÿÿÿ‚ÿ‚ÿÕÿø×ÿû‚ÿíÿø‚ÿ–ÿøïÿãõÿûøÿûïÿûøÿûàÿøõÿòûÿìõÿøòÿòþÿõûÿõøÿøòÿûøÿûõÿøõÿøøÿûøÿûìÿûæÿïòÿþòÿøõÿõûÿøòÿòþÿõûÿøøÿûïÿûøÿûòÿøøÿòþÿõûÿõøÿøòÿûøÿûõÿøõÿø‚ÿÿÿû‚ÿ‚ÿýÿÿÿúÿÿÿèÿÿÿÿÿÿ‚ÿ‚ÿÕÿø×ÿû‚ÿíÿø‚ÿ‚ÿÊÿøãÿøÂÿûïÿøÔÿûõÿþòÿû×ÿø¿ÿû¿ÿûÂÿþÚÿøøÿûøÿûþÿøãÿø×ÿûøÿûòÿû×ÿø‚ÿÏÿû‚ÿ‚ÿÿÿýÿ÷ÿÿÿèÿÿÿýÿÿ‚ÿ‚ÿÕÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ’ÿû‚ÿ‚ÿ”ÿû‚ÿ‚ÿÿÿÿ÷ÿÿÿëÿ ÿÿÿÿþÿÿ‚ÿ‚ÿÕÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ’ÿû‚ÿ‚ÿ”ÿû‚ÿ‚ÿÿÿÿôÿÿëÿ ÿÿÿÿþÿ ÿÿÿÿ‚ÿ‚ÿÜÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ’ÿû‚ÿ‚ÿ”ÿû‚ÿ‚ÿÿÿÿôÿÿëÿ ÿÿÿÿþÿ ÿÿÿÿ‚ÿ‚ÿÜÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ’ÿû‚ÿ‚ÿ”ÿû‚ÿ‚ÿÿÿÿôÿ ÿÿÿÿòÿ ÿÿÿÿþÿ ÿÿÿÿ‚ÿ‚ÿÜÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ˜ÿï‚ÿ‚ÿšÿû‚ÿ‚ÿÿÿÿôÿ ÿÿÿÿòÿÿÿÿûÿ ÿÿÿÿ‚ÿ‚ÿÜÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿžÿû‚ÿ‚ÿÿÿÿôÿ ÿÿÿÿõÿ ÿÿÿÿøÿÿÿÿ‚ÿ‚ÿÜÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿžÿû‚ÿ‚ÿÿÿîÿÿñÿ ÿÿÿÿûÿÿþ ÿÿÿÿ‚ÿ‚ÿßÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿžÿû‚ÿƒÿýÿîÿÿÿôÿÿÿÿÿÿûÿ ÿÿÿÿ‚ÿ‚ÿßÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿžÿû‚ÿ„ÿÿÿîÿÿÿ÷ÿÿÿÿÿÿøÿ ÿÿÿÿ‚ÿ‚ÿßÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿžÿû‚ÿ„ÿÿÿîÿÿÿ÷ÿÿÿÿÿÿøÿ ÿÿÿÿ‚ÿ‚ÿßÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿžÿû‚ÿ„ÿÿÿîÿÿÿ÷ÿ ÿÿÿÿõÿ ÿÿÿÿ‚ÿ‚ÿßÿø×ÿû‚ÿíÿø‚ÿ–ÿøãÿøæÿøãÿø×ÿþ‚ÿçÿþ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÐÿû‚ÿ„ÿÿÿíÿý ÿÿÿÿþÿ ÿÿÿÿõÿ ÿÿÿÿ‚ÿ‚ÿßÿø×ÿû‚ÿíÿø‚ÿœÿïìÿûøÿþïÿûøÿûïÿûøÿûàÿø‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÓÿû‚ÿ„ÿÿÿëÿ ÿÿÿÿþ ÿÿÿÿïÿÿÿÿ‚ÿ‚ÿßÿø×ÿû‚ÿíÿø‚ÿŸÿþõÿøòÿûõÿûòÿûõÿûõÿûõÿûÝÿþ‚ÿçÿþ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÐÿû‚ÿ„ÿÿÿëÿ ÿÿÿÿþÿÿëÿÿÿ‚ÿ‚ÿÞÿø×ÿû‚ÿíÿø‚ÿ¢ÿþïÿûòÿûòÿûøÿûòÿûõÿûòÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿû‚ÿ„ÿÿÿêÿýÿÿÿÿÿëÿ ÿÿÿÿ‚ÿ‚ÿâÿø×ÿû‚ÿíÿø‚ÿ¢ÿþïÿûõÿûïÿûøÿûïÿûûÿûïÿûËÿþ•ÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ»ÿû‚ÿ„ÿÿÿÿëÿýÿÿÿÿÿÿÿïÿ ÿÿÿÿ‚ÿ‚ÿâÿø×ÿû‚ÿíÿø‚ÿÿûõÿûïÿøþÿøïÿûûÿûïÿøÑÿû•ÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ»ÿû‚ÿ„ÿÿÿÿèÿýÿÿÿÿÿÿïÿ ÿÿÿÿ‚ÿ‚ÿâÿø×ÿû‚ÿíÿø‚ÿÿûòÿûïÿøþÿûìÿûûÿûìÿûæÿøûÿìøÿþûÿøõÿûûÿøûÿûûÿûøÿïõÿûòÿûûÿûòÿøþÿõïÿþûÿû‚ÿ‚ÿ‚ÿ‚ÿ½ÿû‚ÿ‡ÿÿÿäÿÿÿÿÿÿìÿ ÿÿÿÿ‚ÿ‚ÿâÿø×ÿû‚ÿíÿø‚ÿÿþòÿøïÿøþÿûìÿûûÿûìÿûéÿõõÿûòÿþõÿûûÿõþÿõûÿþõÿûõÿûõÿõõÿûõÿûõÿòþÿøõÿûøÿþ‚ÿ‚ÿ‚ÿ‚ÿ½ÿû‚ÿ‡ÿÿÿáÿ ÿÿÿÿìÿ ÿÿÿÿ‚ÿ‚ÿâÿø×ÿû‚ÿíÿøËÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÍÿõõÿøïÿøþÿûìÿûûÿûìÿûæÿøõÿûõÿûòÿûøÿøòÿûõÿûõÿûïÿûøÿûïÿûõÿûõÿûõÿþ‚ÿ‚ÿ‚ÿ‚ÿ®ÿû‚ÿ‡ÿÿÿáÿ ÿÿÿéÿ ÿÿÿÿ‚ÿ‚ÿåÿÿø×ÿû‚ÿíÿøËÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÇÿøøÿøïÿøþÿûìÿûûÿûìÿûæÿøõÿûõÿþïÿûøÿûìÿþõÿûõÿûïÿûøÿûïÿûõÿûõÿûõÿû‚ÿ‚ÿ‚ÿ‚ÿ±ÿû‚ÿ‡ÿÿÿÛÿãÿÿÿÿ‚ÿ‚ÿåÿÿø×ÿû‚ÿíÿø‚ÿÿøûÿøïÿøþÿûìÿûûÿûìÿûæÿøõÿûõÿþàÿûàÿøõÿûïÿûøÿûìÿûøÿûõÿûõÿõ‚ÿ‚ÿ‚ÿ‚ÿ·ÿû‚ÿ‡ÿÿÿÿ¼ÿ ÿÿÿÿ‚ÿ‚ÿëÿÿÿø×ÿû‚ÿíÿø‚ÿŠÿûøÿûïÿøþÿûìÿûûÿûìÿûæÿøõÿûõÿþàÿûéÿûûÿûõÿûïÿûøÿûìÿûøÿûõÿûòÿõ‚ÿ‚ÿ‚ÿ‚ÿºÿû‚ÿ‡ÿÿ¸ÿ ÿÿÿÿ‚ÿ‚ÿëÿÿÿø×ÿû‚ÿíÿø‚ÿŠÿûøÿûïÿøþÿûìÿûûÿûìÿûæÿøõÿûõÿþàÿûìÿûøÿûõÿûïÿûøÿûìÿûøÿûõÿûïÿõ‚ÿ‚ÿ‚ÿ‚ÿ½ÿû‚ÿ‡ÿÿ¸ÿ ÿÿÿÿ‚ÿªÿÿÿËÿÿÿø×ÿû‚ÿíÿø‚ÿŠÿûøÿûïÿûøÿûïÿûûÿûïÿûãÿøõÿûõÿûãÿûïÿûõÿûõÿûïÿûøÿûìÿþõÿûõÿûéÿø‚ÿ‚ÿ‚ÿ‚ÿÀÿû‚ÿ‡ÿÿµÿÿÿÿ‚ÿªÿÿÿýÿÿÿÚÿÿÿÿø×ÿû‚ÿíÿø‚ÿŠÿþõÿøòÿûøÿûòÿûõÿûòÿûãÿøõÿûõÿøæÿûïÿûõÿûõÿûïÿûøÿøòÿûõÿûõÿûõÿþõÿø‚ÿ‚ÿ‚ÿ‚ÿÃÿû‚ÿ‡ÿÿµÿ ÿÿÿÿ‚ÿ­ÿÿÿýÿÿÿÝÿ ÿÿÿÿö×ÿû‚ÿíÿø‚ÿÿûòÿûõÿûõÿøõÿûõÿûõÿûàÿøõÿûõÿõøÿûøÿûïÿûõÿûõÿûïÿûõÿûòÿûõÿûõÿûõÿþòÿû‚ÿ‚ÿ‚ÿ‚ÿÃÿû‚ÿŠÿÿÿµÿÿÿÿ‚ÿªÿÿÿúÿÿÝÿ ÿÿÿÿö×ÿû‚ÿíÿø‚ÿ¢ÿøõÿþìÿþõÿûòÿûõÿþïÿûøÿûàÿøõÿøþÿþûÿìõÿûïÿøûÿøõÿøþÿþøÿûõÿøõÿþòÿûõÿûõÿþõÿû‚ÿ‚ÿ‚ÿ‚ÿÀÿû‚ÿŠÿÿÿµÿ ÿÿÿÿ‚ÿ­ÿÿ÷ÿÿÿãÿ ÿÿÿÿÿ÷×ÿû‚ÿíÿø‚ÿ¢ÿïãÿõæÿõéÿõàÿïõÿøõÿòøÿìõÿøûÿøøÿõþÿìõÿòõÿòþÿïûÿï‚ÿ‚ÿ‚ÿ‚ÿ½ÿû‚ÿŠÿÿÿµÿ ÿÿÿÿ‚ÿ°ÿÿÿ÷ÿÿÿãÿ ÿÿÿÿÿ÷×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿžÿû‚ÿŠÿÿÿµÿ ÿÿÿÿ‚ÿ°ÿÿÿ÷ÿÿÿæÿÿÿÿÿÿÿ÷×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿžÿû‚ÿŠÿÿÿÿ¶ÿ ÿÿÿÿ‚ÿ°ÿÿÿ÷ÿÿÿæÿÿÿÿÿÿÿö×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿžÿû‚ÿÿÿÿ¯ÿÿÿ‚ÿ¯ÿÿÿôÿÿæÿÿÿÿÿÿÿö×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿžÿû‚ÿÿÿÿ¯ÿ ÿÿÿÿ‚ÿ³ÿÿñÿÿÿìÿÿÿÿÿÿÿÿö×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿžÿû‚ÿÿÿÿ¯ÿ ÿÿÿÿ‚ÿ¶ÿÿÿñÿÿÿìÿ ÿÿÿÿýÿÿö×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿžÿû‚ÿÿÿÿ¯ÿ ÿÿÿÿ‚ÿ¶ÿÿÿîÿÿïÿÿþÿÿÿúÿÿö×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÞÿÿ‚ÿÆÿû‚ÿÿÿÿ¯ÿ ÿÿÿÿ‚ÿ¶ÿÿÿîÿÿïÿÿÿöÿÿö×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿäÿ ÿÿÿ‚ÿÆÿû‚ÿÿÿÿ¬ÿÿÿÿ‚ÿ¶ÿÿëÿÿïÿÿÿöÿÿö×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿäÿ ÿÿÿ‚ÿÆÿû‚ÿÿÿ©ÿÿÿ‚ÿµÿÿìÿÿÿÿõÿÿÿöÿÿÿö×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿäÿ ÿÿÿÿ‚ÿÉÿû‚ÿÿÿÿ©ÿÿÿ‚ÿµÿÿõÿÿÿÿÿÿÿõÿÿÿîÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿäÿ ÿÿÿÿ‚ÿÉÿû‚ÿÿÿÿ©ÿÿÿ‚ÿ¼ÿ)ÿÿÿÿÿÿÿÿÿÿÿÿÿÿøÿÿÿëÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿäÿ ÿÿÿÿ‚ÿÉÿû‚ÿÿÿÿ©ÿÿÿ‚ÿ¿ÿ(ÿÿÿÿÿÿÿÿÿÿÿÿÿôÿÿÿëÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿäÿ ÿÿÿÿ‚ÿÉÿû‚ÿÿÿÿ¦ÿ ÿÿÿÿ‚ÿÉÿÿÿÿÿÿÿÿÿÿúÿ ÿÿÿúÿ ÿÿÿëÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿäÿ ÿÿÿÿ‚ÿÉÿû‚ÿÿÿÿ¦ÿ ÿÿÿÿ‚ÿÉÿÿÿ÷ÿÿïÿ ÿÿÿýÿÿÿèÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿäÿ ÿÿÿÿ‚ÿÉÿû‚ÿÿÿÿ£ÿ ÿÿÿÿ‚ÿÏÿÿÿ÷ÿÿÿÿïÿÿÿÿÿÿåÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿçÿÿÿÿÿÿ‚ÿÉÿû‚ÿÿÿ ÿ ÿÿÿÿßÿÿÿ‚ÿüÿÿÿ÷ÿ ÿÿÿÿìÿ ÿÿÿðÿÿÿûÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿçÿÿÿÿÿÿ‚ÿÉÿû‚ÿ“ÿÿÿ ÿÿÿÿÿÿåÿ ÿÿÿÿ‚ÿ ÿÿÿÿúÿ ÿÿÿÿÍÿÿÿûÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿçÿÿÿÿÿÿ‚ÿÉÿû‚ÿ“ÿÿÿÿ ÿÿÿÿåÿ ÿÿÿÿƒÿÿÿýÿÿÿÿÿÿâÿÿÿñÿÿÿûÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿçÿÿÿÿÿÿ‚ÿÉÿû‚ÿ“ÿÿÿÿ ÿÿÿÿòÿÿüÿÿÿÿÿÿÿ¬ÿÿàÿÿÿÿÿÿÿÿÿßÿÿÿôÿÿÿøÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿçÿÿÿÿÿÿ‚ÿÉÿû‚ÿ“ÿÿ™ÿý ÿÿÿÿûÿÿÿÿÿÿÿÿúÿÿÿ¬ÿÿÿæÿÿÿÿÿÿÿÿÿÙÿÿÿ÷ÿÿÿøÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿçÿÿÿ‚ÿÀÿû‚ÿ“ÿÿ™ÿý#ÿÿÿÿÿÿÿÿÿÿÿÿöÿÿ¬ÿ ÿÿÿìÿÿÿÿÿÿÿÿÿÿÙÿÿÿúÿÿÿõÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿçÿÿÿ‚ÿÀÿû‚ÿ–ÿÿÿ–ÿýÿÿÿÿÿÿýÿ ÿÿÿöÿÿÿ¬ÿÿÿïÿÿÿÿÿÿÿýÿÿÿÖÿÿÿÿÿÿÿõÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿçÿÿÿ‚ÿÀÿû‚ÿ–ÿÿÿ–ÿÿýÿÿÿôÿ ÿÿÿùÿÿÿ©ÿÿûÿÿÿþÿ ÿÿÿöÿÿÿÓÿÿÿÿÿÿòÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿžÿû‚ÿÉÿ ÿÿÿÙÿÿÿÿ—ÿÿÿþÿìÿÿÿöÿÿ©ÿÿÿþÿÿÿþÿÿÿóÿÿÿÍÿÿÿïÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿžÿû‚ÿÌÿ ÿÿÿÿÙÿÿÿÿÿòÿÿÿÿþÿÿùÿÿÿÁÿÿÿñÿÿÿþÿþÿÿÿðÿÿ°ÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿžÿû‚ÿÌÿÿÿÿÿÿßÿÿÿÿÿÿ÷ÿûÿÿÿþÿÿùÿÿÿÁÿÿÿñÿÿÿþÿÿÿíÿÿ°ÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿžÿû‚ÿÏÿ ÿÿÿÿþÿÿßÿÿÿÿÿÿýÿÿÿÿþÿÿÿþÿÿúÿÿÿÁÿÿÿñÿÿÿýÿÿíÿÿÿ°ÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÛÿÿ‚ÿÉÿû‚ÿÏÿÿÿúÿÿÿåÿÿÿ‡ÿÿÿÿÿÿõÿÿÿýÿ ÿÿÿÿÄÿÿÿîÿýÿÿêÿÿÿ°ÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÛÿÿ‚ÿÉÿû‚ÿÒÿÿÿôÿÿÿÿéÿÿÿ„ÿ ÿÿÿïÿÿÿýÿ ÿÿÿÿÊÿÿÿìÿ ÿÿÿíÿÿÿ­ÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÛÿÿ‚ÿÉÿû‚ÿÒÿÿÿôÿÿÿèÿÿÿ‚ÿæÿ ÿÿÿýÿ ÿÿÿÿÍÿÿÿûÿÿÿÿûÿ ÿÿÿÿîÿÿÿ­ÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿçÿÿÿýÿÿ‚ÿÉÿû‚ÿÒÿÿÿôÿ ÿÿÿîÿÿÿ‚ÿàÿ ÿÿÿýÿÿÿÿÍÿÿÿûÿÿÿÿþÿÿÿÿÿÿñÿÿÿªÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿçÿÿÿýÿÿ‚ÿÉÿû‚ÿÕÿÿÿîÿÿÿîÿÿÿ‚ÿÝÿÿÿÿÿÿÿÿÿÓÿÿÿûÿÿÿÿþÿÿÿÿÿÿÿÿôÿÿÿªÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿçÿÿÿýÿÿ‚ÿÉÿû‚ÿÕÿÿÿîÿ ÿÿÿôÿ ÿÿÿ‚ÿÚÿÿÿÿÿÿÿÿÿØÿÿý ÿÿÿÿÿþÿ ÿÿÿüÿÿÿ•ÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ˜ÿÿÿÙÿÿÿýÿÿ‚ÿÉÿû‚ÿÕÿÿÿëÿ ÿÿÿúÿ ÿÿÿ‚ÿÑÿÿÿÿÿÿÿÿÿßÿÿÿÿÿÿÿÿÿÿÿöÿ’ÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ˜ÿÿÿÙÿÿÿýÿÿ‚ÿÉÿû‚ÿÕÿÿÿëÿ ÿÿÿÿÿþÿÿÿ‚ÿÊÿýÿÿÿÿÿÿÿäÿýÿÿÿÿÿÿÿÿÿ‚ÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ˜ÿ ÿÿÿÜÿÿÿýÿÿ‚ÿÉÿû‚ÿØÿÿÿâÿÿÿÿÿÿÿÿ‚ÿÈÿÿþÿÿÿþÿÿÿëÿÿÿÿÿÿÿÿ‚ÿóÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ˜ÿ ÿÿÿÜÿÿÿýÿÿ‚ÿÉÿû‚ÿØÿÿÿßÿÿÿÿÿÿ‚ÿÅÿ ÿÿÿûÿ ÿÿÿÿôÿÿÿÿÿÿÿÿ‚ÿðÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ˜ÿ ÿÿÿÜÿÿÿýÿÿ‚ÿÉÿû‚ÿØÿÿ‚ÿŽÿÿÿõÿ ÿÿÿúÿÿÿÿÿÿÿÿ‚ÿíÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ˜ÿ ÿÿÿÜÿÿÿýÿÿ‚ÿÉÿû‚ÿÛÿÿÿ‚ÿŽÿ ÿÿÿõÿÿÿÿÿÿÿÿÿÿþÿÿ‚ÿêÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ˜ÿ ÿÿÿÜÿÿÿýÿÿ‚ÿÉÿû‚ÿÛÿÿÿ‚ÿ‹ÿÿÿòÿÿÿÿÿÿÿÿÿ‚ÿäÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ˜ÿ ÿÿÿÜÿÿÿýÿÿ‚ÿÉÿû‚ÿÞÿÿÿ‚ÿˆÿ ÿÿÿõÿÿÿÿ‚ÿÕÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ˜ÿ ÿÿÿÜÿÿÿýÿÿ‚ÿïÿÿàÿû‚ÿÞÿÿÿ‚ÿ‚ÿÿÿ‚ÿÃÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ˜ÿ ÿÿÿÜÿÿÿýÿÿ‚ÿïÿÿÿãÿû‚ÿáÿ ÿÿÿ‚ÿ‚ÿþÿÿÿÿÿÿ‚ÿÏÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ˜ÿ ÿÿÿÜÿÿÿýÿÿ‚ÿòÿ ÿÿÿãÿû‚ÿáÿÿÿ‚ÿ‚ÿûÿÿÿÿÿÿ‚ÿÏÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ˜ÿ ÿÿÿÜÿÿÿ‚ÿéÿ ÿÿÿãÿû‚ÿáÿÿÿ‚ÿ‚ÿõÿ ÿÿÿ‚ÿÏÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ˜ÿ ÿÿÿÜÿÿÿ‚ÿæÿÿÿãÿû‚ÿäÿÿÿ‚ÿ‚ÿ‚ÿµÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ˜ÿ ÿÿÿ‚ÿ¹ÿÿÿãÿû‚ÿçÿÿÿ‚ÿ‚ÿ‚ÿ²ÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ›ÿ ÿÿÿÿ‚ÿ¹ÿÿÿãÿû’ÿ ÿÿÿÿèÿ ÿÿÿ‚ÿ‚ÿ‚ÿ²ÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ›ÿ ÿÿÿÿ‚ÿ¹ÿÿÿãÿû•ÿÿÿÿÿÿÿëÿÿÿ‚ÿ‚ÿ‚ÿ¯ÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ›ÿ ÿÿÿÿ‚ÿ¹ÿÿÿãÿû˜ÿÿÿÿÿÿÿÿÿÿ÷ÿ ÿÿÿ‚ÿ‚ÿ‚ÿ¬ÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ’ÿÿÿÓÿÿ‚ÿïÿÿÿãÿû›ÿ ÿÿÿ÷ÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ©ÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÛÿÿ‚ÿïÿÿÿãÿûžÿÿÿëÿÿÿÿÿÿÿÿû‚ÿêÿø‚ÿêÿû‚ÿêÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÛÿÿÿ‚ÿõÿ ÿÿÿãÿû¡ÿ ÿÿÿåÿÿÿúÿû‚ÿêÿø‚ÿêÿû‚ÿêÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿçÿÿúÿÿÿ‚ÿõÿ ÿÿÿãÿû¤ÿ ÿÿÿÓÿû‚ÿêÿø‚ÿêÿû‚ÿêÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿçÿÿúÿÿÿ‚ÿõÿ ÿÿÿãÿû§ÿ ÿÿÿÐÿû‚ÿêÿø‚ÿêÿû‚ÿêÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿçÿÿúÿÿÿ‚ÿõÿ ÿÿÿãÿûªÿ ÿÿÿÍÿû‚ÿêÿø‚ÿêÿû‚ÿêÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ›ÿÿÿÖÿÿúÿÿÿ‚ÿõÿÿÝÿû°ÿ ÿÿÿÿÊÿû‚ÿêÿø‚ÿêÿû‚ÿêÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ›ÿÿÿÖÿÿúÿÿÿ‚ÿõÿÿÝÿû³ÿ ÿÿÿÿÇÿû‚ÿêÿø‚ÿêÿû‚ÿêÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ›ÿÿÿÿÿÿâÿÿÿúÿÿÿ‚ÿõÿÿÝÿû¹ÿÿÿÿÿÿÄÿû‚ÿêÿø‚ÿêÿû‚ÿêÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ›ÿÿÿÿÿÿâÿÿÿúÿÿÿ‚ÿõÿÿÝÿûÅÿÿÿÿÿÿÿÿ¾ÿû‚ÿêÿø‚ÿêÿû‚ÿêÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ›ÿÿÿÿÿÿâÿÿÿúÿÿÿ‚ÿõÿÿÝÿûÚÿ%ÿÿÿÿÿÿÿÿÿÿÿÿ¸ÿû‚ÿêÿø‚ÿêÿû‚ÿêÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ›ÿÿÿÿÿÿâÿÿÿúÿÿÿ‚ÿõÿÿÝÿûòÿ7ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ²ÿû‚ÿêÿø‚ÿêÿû‚ÿêÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ›ÿÿÿÿÿÿâÿÿÿúÿÿÿ‚ÿõÿ ÿÿÿÿæÿù5ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ£ÿû‚ÿêÿø‚ÿêÿû‚ÿêÿø×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ›ÿÿÿÿÿÿâÿÿÿúÿÿÿ‚ÿøÿÿÿÿÿÿæÿ‚‚‚‚‚×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ›ÿÿÿÿÿÿâÿÿÿúÿÿÿ‚ÿøÿÿÿÿÿÿæÿ‚‚‚‚‚×ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ›ÿÿÿýÿÿâÿÿÿúÿÿÿ‚ÿøÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ»ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ›ÿÿÿýÿÿâÿÿÿ‚ÿéÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ»ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ›ÿÿÿýÿÿâÿÿÿ‚ÿéÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ»ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ›ÿÿÿýÿÿâÿÿÿ‚ÿàÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ»ÿû¼ÿþ¶ÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ›ÿÿÿýÿÿ‚ÿ¹ÿÿÿéÿø‚ÿáÿþ‚ÿ‚ÿÐÿø‚ÿØÿøìÿû¼ÿû¹ÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ›ÿÿÿýÿÿ‚ÿ¹ÿÿÿìÿï‚ÿçÿþ‚ÿäÿû‚ÿùÿûûÿøƒÿûæÿûþÿûïÿû¼ÿõ¿ÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ›ÿÿÿýÿÿ‚ÿòÿÊÿÿÿïÿûûÿõ‚ÿíÿû‚ÿíÿø‚ÿöÿûòÿûŒÿõìÿûòÿþòÿû°ÿøÈÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ›ÿÿÿýÿÿ‚ÿòÿÿÍÿÿÿòÿþòÿø‚ÿðÿþþÿþ‚ÿðÿû‚ÿðÿþïÿû†ÿûìÿûòÿûõÿû§ÿøÑÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿÿÐÿÿ¬ÿ ÿÿÿÐÿÿÿÝÿû‚ÿðÿþþÿþ‚ÿóÿû‚ÿíÿþïÿû†ÿûïÿøòÿûõÿûžÿøÚÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿØÿÿ¬ÿ ÿÿÿÐÿÿÿÝÿû‚ÿóÿþûÿþ‚ÿöÿø‚ÿíÿûòÿû†ÿûïÿøòÿøøÿûžÿòàÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿØÿÿÜÿÓÿ ÿÿÿÙÿÿÿÿÿÿÝÿû‚ÿöÿþøÿþ‚ÿöÿû‚ÿêÿøõÿþƒÿûïÿûìÿûøÿû§ÿïþÿøæÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿêÿÿÿ÷ÿÿÜÿÿÖÿ ÿÿÿÙÿÿÿÿÿÿÝÿû‚ÿùÿþõÿþ‚ÿùÿøþÿø‚ÿóÿøþÿû‚ÿÿÿûïÿûìÿûøÿû­ÿïïÿûìÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿêÿÿÿ÷ÿÿÜÿÿÖÿ ÿÿÿÙÿÿÿÿÿÿàÿû‚ÿöÿþõÿþ‚ÿùÿõûÿø‚ÿöÿõ‚ÿüÿûïÿûìÿûøÿû¼ÿþþÿìæÿøòÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿêÿÿÿ÷ÿÿÜÿÿÖÿ ÿÿÿÙÿÿÔÿû‚ÿùÿþòÿþ‚ÿùÿûòÿø‚ÿöÿõ‚ÿÿÿûïÿûìÿûøÿû¼ÿìÝÿûòÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ›ÿÿÖÿÿôÿÿßÿÿÿÖÿ ÿÿÿÙÿÿÔÿþ‚ÿùÿþïÿþ‚ÿùÿûïÿû‚ÿüÿûþÿõƒÿûïÿûìÿûøÿû¼ÿòÚÿøòÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ›ÿÿÖÿÿôÿÿßÿÿÿÖÿÿÓÿÿ×ÿþ‚ÿùÿûïÿþ‚ÿùÿûïÿøƒÿûõÿø†ÿûïÿûìÿûøÿû¼ÿøÔÿøòÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ›ÿÿúÿÿÿåÿÿôÿÿßÿÿÿÖÿÿÓÿÿÚÿþ‚ÿöÿ݃ÿûïÿøƒÿûòÿû†ÿûïÿûìÿûøÿû¼ÿþÎÿøòÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ›ÿÿúÿÿÿåÿÿôÿÿÿâÿÿÿÖÿÿÓÿÿÝÿþ‚ÿÛÿþ‚ÿùÿûïÿøƒÿþìÿþ†ÿûïÿøòÿûõÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ›ÿÿúÿÿÿåÿÿôÿÿÿâÿÿÿ£ÿÿàÿþ‚ÿØÿþ‚ÿùÿûïÿû‚ÿÿÿûïÿþ†ÿûìÿûòÿûõÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ›ÿÿúÿÿÿåÿÿôÿÿÿâÿ ÿÿÿ¦ÿÿãÿþìÿþ‚ÿíÿþ‚ÿöÿûòÿû‚ÿÿÿûïÿþ†ÿûìÿûòÿûõÿû¼ÿþàÿþÚÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ›ÿÿúÿÿÿåÿÿôÿÿÿâÿ ÿÿÿ¦ÿÿúÿÿòÿã‚ÿíÿþ‚ÿöÿûòÿþ‚ÿùÿûõÿþƒÿûéÿûøÿûòÿû¼ÿþÝÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿžÿÿÿúÿÿÿåÿÿôÿÿÿâÿ ÿÿÿÓÿÿÿÜÿÿúÿÿõÿã‚ÿêÿþ‚ÿóÿûøÿþ‚ÿóÿò‰ÿììÿòïÿû¼ÿþàÿøàÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿžÿÿÿúÿÿÿåÿÿôÿÿÿâÿ ÿÿÿÿÖÿÿÿÜÿÿúÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ»ÿûËÿÅàÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿžÿÿÿúÿÿÿåÿÿôÿÿÿâÿ ÿÿÿÿÖÿÿÿßÿÿÿúÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ»ÿûÅÿÎÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿžÿÿÿúÿÿÿåÿÿÍÿ ÿÿÿÿÖÿÿÿßÿÿÿúÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ»ÿûÂÿÔÚÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿžÿÿÿúÿÿÿåÿÿþÿÿÿØÿ ÿÿÿÿÜÿ ÿÿÿÿßÿÿÿúÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ»ÿû¿ÿû¶ÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿžÿÿÿúÿÿÿåÿÿýÿÿÿØÿ ÿÿÿÿÜÿ ÿÿÿÿÐÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ»ÿû¼ÿþ¶ÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿÿ‚ÿõÿÿÿúÿÿÿàÿ ÿÿÿØÿ ÿÿÿÿßÿÿÿÿÿÿÐÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¾ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿÿÓÿ¦ÿÿÿúÿÿÿàÿ ÿÿÿØÿ ÿÿÿÿßÿÿÿÿÿÿÐÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¾ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿÿÓÿÿ©ÿÿÿúÿÿÿàÿ ÿÿÿÒÿÿÿßÿÿÿÿÿÿÐÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¾ÿû•ÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ²ÿ ÿÿÿÙÿÿÿ©ÿÿÿúÿÿÿàÿ ÿÿÿÒÿÿÿßÿÿÿÿÿÿÐÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¾ÿûÑÿûõÿÔÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ²ÿÿÿÖÿ ÿÿÿÿÿÿàÿÿÿÿÿÿÿÿÜÿÿÿßÿÿÿÿÿÿÐÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¾ÿûÔÿøòÿ×Ýÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ²ÿÿÿÖÿÿ‚ÿíÿÿÿÿÿÿÿÿÜÿÿÿßÿÿÿÿÿÿÐÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¾ÿûÔÿøòÿ×Ýÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ²ÿÿÿÖÿÿ‚ÿðÿÿÿÿÿÿÿÿÿÙÿÿßÿÿÿÿÿÿßÿÿÿúÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¾ÿûÑÿûïÿþàÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ²ÿÿÿÖÿÿ‚ÿòÿýÿÿÿÿÿÿÿÿÙÿÿßÿÿÿÿÿÿßÿÿÿúÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¾ÿû¹ÿþ¹ÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ²ÿÿÿÖÿÿ‚ÿòÿýÿÿÿÿÿÿÿÿåÿÿÿýÿÿßÿÿÿÿÿÿßÿÿÿúÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¾ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ²ÿÿÿÖÿÿ‚ÿòÿýÿÿÿÿþ ÿÿÿÿåÿÿÿÖÿÿÿÿÿÿßÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ²ÿ ÿÿÿÙÿÿ¦ÿÿÿÖÿýÿÿÿÿþÿÿÿþÿåÿÿÿÖÿ ÿÿÿÿÜÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿû¡ÿø×ÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ²ÿ ÿÿÿÙÿ ÿÿÿ¬ÿÿÿÖÿýÿÿýÿ ÿÿÿÿåÿÿÿÖÿÿÿÖÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿû¼ÿõõÿòÚÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ²ÿ ÿÿÿÙÿ ÿÿÿ¬ÿÿÿ÷ÿÿåÿýÿÿýÿ ÿÿÿÿåÿÿÿÖÿÿÓÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿû¼ÿûòÿõþÿûÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ²ÿ ÿÿÿÜÿ ÿÿÿÿ¬ÿÿÿ÷ÿÿèÿÿýÿÿÿþÿ ÿÿÿÿåÿÿÿÖÿÿÓÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿû¼ÿþòÿõøÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ²ÿ ÿÿÿÜÿ ÿÿÿÿ¬ÿÿÿ÷ÿÿèÿý ÿÿÿÿþÿ ÿÿÿÿåÿÿÿ£ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿû¿ÿþïÿøòÿþàÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿµÿ ÿÿÿÿÜÿ ÿÿÿÿÙÿÿÿÜÿÿÿ÷ÿÿèÿýÿÿúÿ ÿÿÿÿåÿÿÿýÿÿ¬ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿû¿ÿþòÿøïÿþàÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿµÿ ÿÿÿÿÜÿ ÿÿÿÿÙÿÿÿÜÿÿÿ÷ÿÿìÿ ÿÿÿÿúÿ ÿÿÿÿåÿÿÿýÿÿ¬ÿÿÿúÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¾ÿû¿ÿûøÿõòÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿµÿ ÿÿÿÿÜÿ ÿÿÿÿÖÿÿÜÿÿÿ÷ÿÿïÿÿÿÿÿÿÿûÿ ÿÿÿÿåÿÿÿýÿÿÓÿÿßÿÿÿ÷ÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¾ÿû¼ÿûþÿõïÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿÿÓÿÿÖÿÿÜÿÿÿ÷ÿÿïÿ ÿÿÿÿ÷ÿ ÿÿÿÿåÿÿúÿÿÓÿÿßÿÿÿ÷ÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¾ÿû¼ÿìòÿûÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿÿÿÖÿÿÖÿÿÜÿÿÿ÷ÿÿïÿÿÿÿÿÿøÿ ÿÿÿÿåÿÿúÿÿÓÿÿßÿÿÿ÷ÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¾ÿû¶ÿøõÿòÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿÿÿÖÿÿÖÿÿÜÿÿÿ÷ÿÿïÿÿÿÿÿÿøÿÿÿÿÿÿèÿÿúÿÿâÿÿÿúÿÿßÿÿÿ÷ÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¾ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿÿÿÖÿÿÖÿÿÜÿÿÿ÷ÿÿïÿÿÿÿÿÿøÿÿÿÿÿÿèÿÿúÿÿâÿÿÿúÿÿßÿÿÿ÷ÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¾ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿèÿÇÿÿÿÖÿÿÿÙÿÿÜÿÿÿ÷ÿÿÿòÿÿÿÿÿÿøÿÿÿÿÿÿÿëÿÿúÿÿâÿÿÿúÿÿÍÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¾ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿèÿÿÊÿÿÿÖÿÿÿÙÿÿÿßÿÿÿ÷ÿÿÿõÿÿÿîÿÿÿÿÿÿÿëÿÿúÿÿÿåÿÿÿúÿÿÿÐÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¾ÿû•ÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿèÿÿÿÍÿÿÿßÿÿýÿÿÿßÿ ÿÿÿÿßÿÿÿ÷ÿÿÿõÿÿÿÿÿÿÿõÿÿÿÿÿÿßÿÿÿåÿÿÿúÿÿÿÐÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¾ÿû¶ÿÝÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿèÿÿÿÖÿÿÿÿÿÿßÿÿýÿÿÿßÿ ÿÿÿÿßÿÿôÿÿÿõÿÿÿÿÿÿòÿÿÿÿÿÿßÿÿÿåÿÿÿúÿÿÿÐÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¾ÿû¼ÿ×Ýÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿèÿÿÿÖÿ ÿÿÿÿÜÿÿýÿÿÿßÿ ÿÿÿÿÍÿÿÿõÿÿÿýÿÿòÿÿÿÿþÿÿßÿÿÿåÿÿÿúÿÿÿÐÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¾ÿû¿ÿÔÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿèÿÿÿÖÿÿÓÿÿýÿÿÿßÿ ÿÿÿÿàÿÿóÿÿÿõÿÿÿëÿÿÿÿÿÿßÿÿÿåÿÿÿúÿÿÿÐÿÿåÿ ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿåÿû¿ÿøàÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿèÿÿÿÖÿÿÓÿÿÓÿ ÿÿÿÿàÿÿÿâÿÿÿëÿÿÿÿÿÿßÿÿÿåÿÿÿúÿÿÿÐÿÿåÿ ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿåÿû¿ÿû¶ÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿåÿÿÖÿÿÓÿÿÓÿ ÿÿÿÿãÿ ÿÿÿâÿÿüÿÿòÿ ÿÿÿÿÿþáÿÿÿåÿÿÿúÿÿÿâÿÿôÿÿåÿ ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿåÿû¼ÿþ¶ÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿåÿÿÖÿÿÓÿÿÓÿ ÿÿÿÿãÿ ÿÿÿâÿÿüÿÿòÿ ÿÿÿÿþÿÿäÿÿÿåÿÿÿúÿÿÿâÿÿôÿÿåÿ ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿåÿû¹ÿþ¹ÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿåÿÿÖÿÿÓÿÿÓÿÿÚÿ ÿÿÿâÿÿüÿÿòÿÿÿÿÿÿÿðÿÿúÿÿâÿÿÿúÿÿÿâÿÿôÿÿåÿ ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿåÿû¹ÿþàÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿåÿÿÿÙÿÿÓÿÿÓÿÿÚÿ ÿÿÿâÿÿüÿÿòÿÿÿÿÿÿÿðÿÿÖÿÿÿúÿÿÿâÿÿÓÿ ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿåÿû¶ÿÝÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿëÿ ÿÿÿÿÙÿÿúÿÿßÿÿÓÿÿÚÿ ÿÿÿÿåÿÿÿÿÿÿòÿÿÿÿÿÿÿÿóÿÿÖÿÿÿÓÿÿÓÿ ÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿèÿû¼ÿ×Ýÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿëÿ ÿÿÿÿÙÿÿúÿÿßÿÿýÿÿÿßÿÿÚÿ ÿÿÿÿùÿÿÿõÿÿÿÿÿÿòÿÿÿÿÿÿÿÿóÿÿÖÿÿÿÓÿÿÓÿ ÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿèÿû¼ÿ×Ýÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿëÿ ÿÿÿÿÙÿÿúÿÿßÿÿýÿÿÿßÿÿÚÿ ÿÿÿÿùÿÿÿõÿÿÿÿÿÿïÿÿÿÿÿÿÿóÿÿÖÿÿÿÖÿÿÿÓÿ ÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿèÿû¹ÿþàÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿëÿ ÿÿÿÿÙÿÿúÿÿßÿÿýÿÿÿßÿÿÚÿ ÿÿÿÿýÿÿþÿÿÿøÿÿÿÿÿÿÿïÿÿÿÿÿÿÿöÿÿÿÖÿÿÿÖÿÿÿýÿÿÛÿ ÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿèÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿëÿ ÿÿÿÿÙÿÿúÿÿßÿÿýÿÿÿâÿÿÿÚÿ ÿÿÿÿýÿÿþÿÿ÷ÿÿÿÿÿÿÿïÿÿÿÿÿÿÿöÿÿÿ£ÿÿÿýÿÿÛÿ ÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿèÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿëÿ ÿÿÿÿÙÿÿúÿÿßÿÿýÿÿÿâÿÿÿýÿÿÿéÿÿÿÿÿÿýÿ ÿÿÿ÷ÿÿÿüÿÿïÿ ÿÿÿÿþÿÿöÿÿÿ÷ÿÿ²ÿÿÿýÿÿÿÞÿ ÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿèÿû¡ÿþÑÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿëÿÿÐÿÿúÿÿßÿÿýÿÿÿâÿÿÿýÿÿÿéÿ ÿÿÿÿýÿýÿ ÿÿÿ÷ÿÿÿÿÿÿÿîÿÿÿþÿþÿÿöÿÿÿ÷ÿÿ²ÿÿý ÿÿÿÿÿÿýÿçÿ ÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿèÿû¶ÿøòÿû×ÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿëÿÿÐÿÿúÿÿâÿÿÿýÿÿÿÖÿÿÿéÿ ÿÿÿÿýÿýÿ ÿÿÿÿúÿÿÿÿÿÿÿîÿÿÿþÿÿÿöÿÿÿ÷ÿÿÓÿÿåÿÿýÿÿÿÿÿÿþÿÿíÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿèÿû¹ÿõïÿþ×ÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿëÿÿÄÿÿÖÿÿÿÖÿÿÿéÿ ÿÿÿÿýÿÿÿÿÿÿÿúÿÿÿÿÿÿÿîÿÿÿûÿÿöÿÿÿ÷ÿÿÓÿÿåÿÿýÿÿÿÿÿÿÿÿíÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿèÿû¼ÿòìÿþÚÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿëÿÿÄÿÿÖÿÿÿÖÿÿÿéÿ ÿÿÿÿýÿÿÿÿÿÿÿýÿÿþÿüÿÿÿîÿÿÿûÿÿöÿÿÿ÷ÿÿÓÿÿåÿÿýÿÿÿÿÿÿÿÿÿðÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿèÿû¼ÿøþÿþìÿûÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿëÿÿÄÿÿÖÿÿÿÖÿÿÿéÿ ÿÿÿÿþÿÿÿÿÿÿÿýÿÿþÿüÿÿÿàÿÿöÿÿÿ÷ÿÿåÿÿÿ÷ÿÿåÿÿýÿÿÿþÿÿÿÿÿÿíÿÿýÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿèÿû¿ÿûøÿþìÿûÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿÿÿÄÿÿÖÿÿÿÖÿÿÿéÿ ÿÿÿÿÿþ ÿÿÿÿÿýÿúÿÿüÿÿÿàÿÿÿùÿÿÿ÷ÿÿåÿÿÿ÷ÿÿåÿÿýÿÿÿþÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÆÿû¿ÿûøÿþìÿøàÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿÿÿÄÿÿÓÿÿÖÿÿÿéÿ ÿÿÿÿþÿ ÿÿÿÿÿýÿúÿÿüÿÿÿàÿÿÿùÿÿÿ÷ÿÿåÿÿÿ÷ÿÿàÿ ÿÿÿÿþÿÿÿýÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÆÿû¿ÿûøÿþìÿøàÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿÿÿÿÿÿÍÿÿÓÿÿÖÿÿÿéÿ ÿÿÿÿþÿ ÿÿÿÿÿýÿúÿÿÓÿÿÿùÿÿÿ÷ÿÿåÿÿÿ÷ÿÿãÿÿÿÿÿÿýÿÿýÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÆÿû¼ÿþøÿþìÿøàÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿÿÿÿÿÿÍÿÿâÿÿÿúÿÿâÿÿÿýÿÿÿéÿ ÿÿÿÿûÿüÿÿýÿúÿÿÖÿÿþÿÿçÿÿåÿÿôÿÿãÿ ÿÿÿÿúÿÿýÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÆÿû¼ÿþøÿþòÿõÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿÿÿÿÿÿÜÿÿÿúÿÿÿåÿÿÿúÿÿâÿÿÿýÿÿÿìÿÿÿÿÿÿñÿýÿÿýÿÿÖÿÿþÿÿçÿÿåÿÿôÿÿãÿ ÿÿÿÿúÿÿÿýÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÆÿû¹ÿûþÿþøÿòÚÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿåÿÿÿÜÿÿÿÖÿÿÿúÿÿâÿÿÿýÿÿÿìÿ ÿÿÿÿîÿýÿÿÿÿÿáÿÿÿþÿÿþÿÿçÿÿåÿÿôÿÿãÿÿÿöÿÿÿýÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÊÿû¶ÿàÚÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿâÿÿÜÿÿÿÖÿÿÿúÿÿâÿÿÿýÿÿÿìÿ ÿÿÿÿîÿýÿÿÿÿÿáÿÿÿþÿÿÿþÿçÿÿåÿÿôÿÿãÿÿÿöÿÿÿýÿÿÿôÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿßÿû³ÿéÔÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿâÿÿÜÿÿÿÖÿÿÿÖÿÿÿýÿÿÿìÿ ÿÿÿÿìÿÿÿÿÿÿáÿÿÿûÿÿþÿçÿÿåÿÿôÿÿãÿÿÿöÿÿÿýÿÿóÿÿúÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿèÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿâÿÿÜÿÿÿÖÿÿÿÖÿÿÿýÿÿÿìÿ ÿÿÿÿéÿ ÿÿÿÿüÿÿÿîÿÿÿûÿÿþÿçÿÿìÿ ÿÿÿÿôÿÿåÿýÿÿöÿÿÿýÿÿóÿÿúÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿèÿû˜ÿþÚÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿâÿÿÜÿÿÿÖÿÿÿÖÿÿÿýÿÿÿìÿ ÿÿÿÿéÿ ÿÿÿùÿÿÿîÿÿÿûÿÿþÿçÿÿïÿÿÿÿÿÿôÿÿåÿýÿÿöÿÿÿýÿÿóÿÿúÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿèÿû¼ÿþÝÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿâÿÿÜÿÿÿÖÿÿÓÿÿÿàÿÿÿåÿ ÿÿÿùÿÿÿîÿÿÿûÿÿþÿùÿÿÝÿÿÿÿÿÿôÿÿåÿýÿÿóÿÿýÿÿóÿÿúÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿèÿû¼ÿþÝÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿÿúÿÿÜÿÿÿÖÿÿÓÿÿÿàÿÿÿåÿ ÿÿÿùÿÿÿîÿÿÿûÿÿþÿùÿÿÝÿÿÿÿÿÿôÿÿåÿýÿÿîÿÿÿóÿÿúÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿèÿû¼ÿþàÿøàÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿÿúÿÿÿßÿÿÿúÿÿÿåÿÿÓÿÿÿàÿ ÿÿÿÿéÿ ÿÿÿùÿÿÿîÿÿÿûÿÿþÿùÿÿÝÿÿÿÿÿÿÓÿýÿëÿÿÿóÿÿúÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿèÿûÈÿÈàÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿÿúÿÿÿßÿÿÿúÿÿÿåÿÿ÷ÿÿÿåÿÿÿàÿ ÿÿÿÿîÿÿýÿÿÿùÿÿÿîÿÿÿøÿÿÿÿÿÿÿÝÿ ÿÿÿÿÓÿÿþÿëÿÿÿóÿÿúÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿèÿûÅÿÎÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿÿúÿÿÿßÿÿÿúÿÿÿåÿÿ÷ÿÿÿåÿÿÝÿ ÿÿÿÿîÿÿÿýÿöÿÿÿîÿÿÿøÿÿÿÿÿÿÿàÿÿÿÿÿÿÒÿýÿëÿÿÿÿÿÿúÿÿúÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿèÿûÂÿÔÚÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ“ÿßÿÿúÿÿÿßÿÿ÷ÿÿÿåÿÿ÷ÿÿÿåÿÿÝÿ ÿÿÿÿîÿÿÿñÿÿÿîÿÿÿøÿÿÿÿÿÿÿàÿÿÿÿÿÿÓÿÿÿëÿÿÿÿÿÿúÿÿúÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿèÿû¿ÿû¶ÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ–ÿÿÿâÿÿúÿÿÿßÿÿ÷ÿÿÿåÿÿ÷ÿÿÿåÿÿÝÿ ÿÿÿÿîÿÿÿñÿÿÿëÿÿøÿÿÿÿÿÿÿàÿÿÿÿÿÿÓÿÿÿèÿ ÿÿÿÿúÿÿúÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿëÿû¼ÿþ¶ÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ–ÿÿÿâÿÿúÿÿÿßÿÿ÷ÿÿÿèÿÿÿ÷ÿÿÿåÿÿ÷ÿÿïÿÿþ ÿÿÿÿîÿÿÿñÿÿÿëÿÿøÿÿÿÿÿÿÿôÿÿÿõÿÿÿÿÿÿÓÿÿÿèÿÿÿÿÿÿýÿÿúÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿëÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ–ÿÿÿâÿÿÐÿÿôÿÿèÿÿÿ÷ÿÿÿåÿÿ÷ÿÿïÿÿþ ÿÿÿÿîÿÿÿñÿÿÿëÿÿõÿÿÿÿÿÿôÿÿÿõÿÿýÿÿÿÓÿÿÿðÿÿþÿÿÿÿÿÿýÿÿúÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿëÿû•ÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ“ÿÿâÿÿÐÿÿôÿÿÖÿÿÿÖÿÿïÿÿÿÿÿÿîÿÿÿñÿÿÿëÿÿõÿÿÿÿÿÿôÿÿÿøÿÿÿýÿÿÿóÿÿÿéÿÿÿðÿÿþÿ ÿÿÿÿÿþÿÿÿúÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿëÿû•ÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ“ÿÿâÿÿ¾ÿÿÖÿÿÿÖÿÿïÿÿÿÿÿÿîÿÿÿñÿÿèÿÿõÿÿÿÿÿÿôÿÿÿýÿýÿÿÿýÿÿÿóÿÿÿìÿÿþÿÿðÿÿþÿ ÿÿÿÿÿþÿÿÿúÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿëÿû¹ÿÚÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ“ÿÿÿåÿÿ¾ÿÿÓÿÿÖÿÿÿòÿÿÿÿÿÿîÿÿÿñÿÿèÿÿõÿÿÿÿÿÿôÿÿýÿÿýÿÿÿýÿÿþÿÿÿ÷ÿÿÿøÿÿÿýÿÿþÿÿðÿÿþÿ ÿÿÿÿþÿÿÿùÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿëÿû¼ÿ×Ýÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ“ÿÿÿåÿÿ¾ÿÿÓÿÿÖÿÿÿòÿÿÿÿÿÿîÿÿÿñÿÿ×ÿÿÿÿÿÿöÿÿýÿÿÿÿÿÿüÿý ÿÿÿÿúÿÿÿøÿ ÿÿÿÿÿþÿÿðÿÿþÿ ÿÿÿÿþÿÿÿùÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿëÿû¿ÿõãÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ“ÿÿÿåÿÿ¾ÿÿÓÿÿÖÿÿÿòÿÿÿÿÿÿîÿÿÿñÿÿ×ÿÿÿÿÿÿöÿýÿÿÿÿÿÿÿüÿý ÿÿÿÿúÿÿÿøÿ ÿÿÿÿÿþÿÿðÿÿþÿ ÿÿÿÿþÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÛÿû¿ÿøàÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ“ÿÿÿåÿÿ¾ÿÿÓÿÿÖÿÿÿòÿÿÿÿÿÿëÿÿñÿÿ×ÿÿÿÿÿÿöÿýÿÿÿÿÿÿÿüÿý ÿÿÿÿúÿÿÿûÿÿÿÿÿÿÿþÿÿðÿÿûÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÛÿû¿ÿû¶ÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ™ÿ ÿÿÿÿåÿÿ÷ÿÿÍÿÿÿÖÿÿÖÿÿÿòÿÿÿÿÿÿëÿÿ¿ÿÿÿÿÿÿ÷ÿÿÿÿÿÿÿùÿý ÿÿÿÿÿýÿÿÿûÿÿÿÿÿÿÿþÿíÿÿûÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÛÿû¼ÿþ¶ÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ™ÿ ÿÿÿÿåÿÿ÷ÿÿßÿÿôÿÿÿëÿÿÿôÿÿèÿÿÿ÷ÿÿÿõÿÿþ ÿÿÿÿÿëÿÿ¶ÿÿÿ÷ÿÿÿÿÿÿÿùÿý ÿÿÿÿÿþ ÿÿÿÿûÿÿÿÿÿÿÿÿíÿÿûÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÛÿû¹ÿþ¹ÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ™ÿ ÿÿÿÿåÿÿ÷ÿÿßÿÿôÿÿýÿÿðÿÿÿôÿÿèÿÿÿ÷ÿÿÿõÿÿþ ÿÿÿÿÿëÿÿ¶ÿÿÿ÷ÿÿÿýÿÿÿùÿýÿÿÿÿþ ÿÿÿÿÿûÿÿýÿ ÿÿÿÿíÿÿÿþÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÞÿû¶ÿþãÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿœÿÿÿÿÿÿÖÿÿßÿÿòÿ ÿÿÿðÿÿÿôÿÿèÿÿÿ÷ÿÿÿõÿÿþÿáÿÿÓÿÿÿìÿÿÿ÷ÿÿÿíÿýÿÿýÿÿÿÿÿÿûÿÿýÿ ÿÿÿÿíÿÿÿþÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÞÿû¿ÿÔÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿœÿÿÿÿÿÿÖÿÿßÿÿòÿ ÿÿÿðÿÿÿôÿÿèÿÿÿ÷ÿÿÿøÿÿþÿÿáÿÿÓÿÿÿìÿÿþÿ÷ÿÿêÿýÿÿÿÿÿÿÿÿÿûÿÿýÿ ÿÿÿÿíÿÿÿþÿ ÿÿÿÿÿýÿÿùÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿëÿû¼ÿ×Ýÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿœÿÿÿÿÿÿÖÿÿßÿÿòÿ ÿÿÿÿóÿÿÿõÿäÿÿÿ÷ÿÿÿøÿÿþÿÿ®ÿÿÿòÿÿÿÿþÿÿúÿÿêÿÿýÿÿÿÿÿÿÿÿûÿ ÿÿÿÿþ ÿÿÿÿîÿÿÿûÿ ÿÿÿÿýÿÿùÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿëÿû¼ÿ×Ýÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿœÿÿÿãÿÿðÿÿßÿÿòÿ ÿÿÿÿóÿÿÿøÿÿÿçÿÿÿ÷ÿÿÿøÿÿþÿÿÏÿÿÿèÿÿÿòÿÿÿÿþÿÿÿÿþÿÿêÿÿýÿÿÿÿÿÿÿÿþÿÿÿýÿÿþ ÿÿÿÿîÿÿÿûÿÿüÿýÿÿùÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿëÿû•ÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿœÿÿÿæÿ ÿÿÿóÿÿßÿÿòÿ ÿÿÿÿóÿÿÿøÿÿÿçÿÿÿ÷ÿÿÿøÿÿþÿÌÿÿÿèÿÿÿñÿþÿÿþÿÿÿÿþ ÿÿÿÿîÿÿýÿÿÿýÿÿÿÿþÿÿÿ÷ÿÿÿÿîÿÿÿòÿÿÿþÿùÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿëÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿœÿÿÿæÿ ÿÿÿóÿÿâÿÿÿòÿ ÿÿÿÿóÿÿÿûÿÿÿÿÿÿÿÿñÿÿÿæÿÿÿÌÿÿÿèÿÿÿñÿþÿÿþÿÿÿÿþÿÿêÿÿÿýÿÿýÿÿÿýÿÿÿöÿÿÿîÿÿÿòÿÿÿþÿùÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿëÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿœÿÿÿæÿÿÿÿÿÿ÷ÿÿâÿÿÿòÿÿÿÿþÿ÷ÿ ÿÿÿÿûÿÿÿÿÿÿÿÿñÿÿÿéÿ ÿÿÿÌÿÿÿåÿÿñÿÿþÿþÿÿÿÿþÿÿêÿÿþÿÿúÿ ÿÿÿÿþÿÿöÿÿÿ×ÿÿÿþÿÿüÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿëÿû•ÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿœÿÿÿæÿÿÿÿÿÿ÷ÿÿâÿÿÿõÿ ÿÿÿÿþÿúÿÿÿÿÿÿûÿÿÿÿÿÿÿûÿÿÿüÿÿÿéÿÿÿùÿÿÿÙÿÿÿåÿÿñÿÿþÿÿÿýÿÿçÿÿòÿ ÿÿÿÿþÿóÿÿÿÖÿÿýÿÿüÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿëÿû•ÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿœÿÿÿéÿÿÿÿÿÿÿ÷ÿÿâÿÿÿþÿÿÿÿþÿÿýÿÿúÿÿÿÿÿÿûÿÿÿÿÿÿýÿ ÿÿÿüÿÿÿìÿ ÿÿÿÿúÿÿÿëÿÿôÿÿÿåÿÿñÿÿþÿÿÿýÿÿçÿÿïÿÿÿÿþÿóÿÿÿÖÿÿýÿÿüÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿûÑÿþÈÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿœÿÿÿéÿÿÿÿÿÿÿ÷ÿÿâÿÿÿþÿÿÿþÿÿÿýÿÿÿýÿÿÿÿÿÿûÿÿÿÿÿÿýÿ ÿÿÿüÿÿÿìÿÿÿöÿÿÿëÿÿÿ÷ÿÿÿåÿÿñÿÿûÿÿýÿÿçÿÿïÿ ÿÿÿÿóÿÿÿÖÿÿýÿÿüÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿûÑÿÂÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿœÿÿÿýÿÿòÿÿÿÿÿÿöÿÿâÿÿÿýÿÿÿþÿÿÿýÿÿÿýÿ ÿÿÿÿúÿÿÿÿÿÿýÿÿÿÿÿÿÿÿÿìÿÿÿöÿÿÿëÿÿÿ÷ÿÿÿåÿÿñÿÿûÿ ÿÿÿÿçÿÿïÿ ÿÿÿÿóÿÿÿÖÿÿýÿÿüÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿûÑÿÂÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿœÿÿÿýÿÿÿõÿÿÿÿÿÿöÿÿâÿÿýÿÿÿýÿÿÿýÿÿÿÿÿÿÿÿÿúÿÿÿÿþÿÿýÿÿÿÿÿÿÿÿÿìÿÿÿöÿÿèÿÿÿ÷ÿÿÿåÿÿôÿÿÿûÿ ÿÿÿÿÐÿ ÿÿÿÿóÿÿÓÿÿýÿÿüÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿûÑÿÂÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿœÿÿÿýÿÿÿõÿÿÿÿþÿÿöÿÿâÿÿýÿÿÿýÿÿÿúÿÿÿÿÿÿÿÿýÿ ÿÿÿÿþ!ÿÿÿÿÿÿÿÿÿÿÿÿ÷ÿÿÿþÿÿÿöÿÿèÿÿÿ÷ÿÿÿåÿÿôÿÿÿûÿÿÿÿÿÿÿÿ×ÿ ÿÿÿÿóÿÿèÿÿñÿÿýÿÿüÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿûÑÿþËÿûÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿÿÿõÿÿÿÿþÿÿÒÿÿýÿÿÿýÿÿÿÿûÿ ÿÿÿýÿÿÿýÿ ÿÿÿÿÿýÿÿÿÿÿÿÿÿÿÿÿôÿÿþÿÿóÿÿèÿÿÿ÷ÿÿÿåÿÿôÿÿÿûÿÿÿÿÿÿÿÿ×ÿ ÿÿÿÿóÿÿèÿÿñÿÿýÿÿüÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿûÑÿþÈÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿÿÿøÿÿþÿÿÿÿþÿÒÿý ÿÿÿÿýÿÿÿÿûÿ ÿÿÿýÿÿÿýÿ ÿÿÿÿÿýÿÿÿÿÿÿÿêÿÿþÿÿóÿÿèÿÿÿ÷ÿÿÿåÿÿôÿÿÿûÿÿÿÿÿÿÿÿÖÿýÿÿðÿÿèÿÿñÿÿýÿÿüÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿû•ÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿÿÿûÿÿÿþÿÿÿÿþÿÐÿÿÿÿÿÿÿÿÿÿûÿ ÿÿÿýÿÿÿýÿ ÿÿÿÿÿýÿÿÿýÿÿþÿêÿÿýÿÿóÿÿèÿÿÿ÷ÿÿâÿÿôÿÿÿøÿÿÿÿÿÿÿÖÿýÿÿðÿÿèÿÿñÿÿýÿÿüÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿÿÿøÿÿÿýÿÿþÿÐÿÿÿÿÿÿÿÿÿÿøÿÿ÷ÿÿýÿ ÿÿÿÿÿýÿÿÿúÿÿÿúÿÿùÿÿýÿÿóÿÿèÿÿÿ÷ÿÿâÿÿôÿÿÿõÿüÿÿÿÖÿÿÿîÿÿèÿÿñÿÿþÿþÿüÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿÿÿøÿÿÿüÿýÿÐÿÿÿÿþÿÿÿÿÿÿéÿÿÿÿÿÿÿÿÿÿýÿ÷ÿÿÿýÿ ÿÿÿüÿÿýÿÿöÿÿÿåÿÿ÷ÿÿÐÿÿÿîÿÿÿñÿÿÿîÿÿÿîÿÿèÿÿÿïÿÿþÿüÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿÿÿøÿ ÿÿÿÿÿýÿÿÿÔÿÿÿÿþÿÿÿÿÿÿòÿÿÿÿþ ÿÿÿÿüÿÿÿòÿÿÿýÿ ÿÿÿüÿÿýÿÿöÿÿÿåÿÿúÿÿÿÐÿÿÿîÿÿÿñÿÿÿîÿÿÿîÿÿèÿÿÿìÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿäÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿœÿÿúÿÿÿøÿ ÿÿÿÿÿýÿÿÓÿÿÿÿþÿÿÿÿÿÿòÿÿÿÿþ ÿÿÿÿüÿÿÿòÿÿÿÿÿÿÿÿüÿÿýÿÿöÿÿÿåÿÿúÿÿÿÐÿÿÿîÿÿÿñÿÿÿîÿÿÿÐÿÿÿìÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿäÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿœÿÿúÿÿÿûÿÿÿüÿÿýÿÿùÿÿÿãÿÿÿÿôÿÿìÿÿþÿ ÿÿÿüÿÿÿïÿÿÿÿÿÿÿüÿÿýÿÿöÿÿÿåÿÿÿÄÿÿÿîÿÿÿñÿÿÿîÿÿÿÐÿÿÿìÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿäÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿœÿÿúÿÿÿûÿÿÿüÿÿýÿÿùÿÿÿåÿýÿÿÿôÿÿîÿÿÿýÿÿÿùÿÿïÿÿÿÿÿÿÿüÿÿýÿÿöÿÿÿåÿÿÿ©ÿÿÿñÿÿÿîÿÿÿÐÿÿÿìÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿäÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿœÿÿúÿÿÿþÿ ÿÿÿ÷ÿÿÿùÿÿÿæÿÿÿðÿÿîÿÿÿýÿÿöÿÿïÿ ÿÿÿýÿ ÿÿÿÿÿýÿóÿÿÿåÿÿÿ¦ÿÿñÿÿëÿÿÿÐÿÿÿìÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿäÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿŸÿÿÿúÿÿÿýÿÿÿñÿÿùÿÿÿæÿÿÿØÿÿÿýÿÿöÿÿïÿ ÿÿÿýÿ ÿÿÿÿÿýÿÏÿÿÿÖÿÿÿÙÿÿñÿÿëÿÿÿÐÿÿÿìÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿäÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿŸÿÿÿúÿÿÿýÿÿÿñÿÿùÿÿÿæÿÿÿØÿÿÿÖÿýÿÿÿÿþÿÿÿÿþÿÿÏÿÿÿÖÿÿÿÙÿÿñÿÿèÿÿÐÿÿÿ÷ÿÿÿþÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿŸÿÿÿúÿÿÿýÿëÿÿöÿÿèÿýÿÿØÿÿÿÖÿÿþÿÿÿþÿÿÿÿþÿÿœÿÿÿÙÿÿñÿÿèÿÿñÿÿÿèÿÿÿ÷ÿÿûÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿƒÿÿ£ÿÿÿõÿÿÿëÿ ÿÿÿÿýÿÿèÿýÿÿÿÙÿÿÿÖÿÿÿþÿÿÿþÿÿÿÿÿÃÿÿÜÿÿÙÿÿñÿÿèÿÿñÿÿÿèÿÿÿ÷ÿÿøÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿƒÿÿ£ÿÿÿõÿÿÿëÿÿÿÿÿÿÿÿéÿÿÿÕÿÿÿÖÿÿÿþÿÿÿþÿÿÿÿÿÃÿÿÜÿÿ÷ÿÿèÿÿÿôÿÿèÿÿñÿÿÿèÿÿÿ÷ÿÿøÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿƒÿ ÿÿÿ©ÿÿÿõÿÿÿëÿÿÿÿÿÿÿÿéÿÿÿÕÿÿÿÖÿÿÿûÿÿþ ÿÿÿÿÀÿÿÜÿÿ÷ÿÿÓÿÿèÿÿñÿÿÿèÿÿÿ÷ÿÿøÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ†ÿ ÿÿÿÿ©ÿÿÿõÿÿðÿÿÿþÿÿÿÿÿÿÿéÿÿÿÕÿÿÿÖÿÿÿøÿ ÿÿÿÿÀÿÿÜÿÿÿýÿÿÿÓÿÿèÿÿÿôÿÿÿÙÿÿÿøÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ†ÿ ÿÿÿÿ©ÿÿÿõÿÿðÿÿÿõÿ ÿÿÿÿõÿÿýÿÿÿíÿÿÿñÿÿÿÖÿÿõÿ ÿÿÿÿðÿÿÿÜÿÿÿÜÿÿÿýÿÿÿÓÿÿÓÿÿÿÙÿÿÿõÿ ÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ†ÿ ÿÿÿÿ©ÿÿÿõÿÿðÿÿÿõÿ ÿÿÿÿøÿÿÿÿÿÿÿíÿÿÿñÿÿÿîÿÿÿñÿÿòÿ ÿÿÿðÿÿÿâÿ ÿÿÿÿÜÿÿÿýÿÿÿÓÿÿÓÿÿÿÙÿÿÿõÿ ÿÿÿÿ‚ÿéÿÿ‚ÿ‚ÿ‚ÿŒÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ†ÿ ÿÿÿÿ©ÿÿÿõÿÿðÿÿÿõÿ ÿÿÿÿøÿÿÿÿÿÿÿÿîÿÿÿñÿÿÿîÿÿÿñÿÿòÿ ÿÿÿðÿÿÿâÿ ÿÿÿÿÜÿÿÿýÿÿÿÖÿÿÿÓÿÿÿÙÿÿÿõÿ ÿÿÿÿ‚ÿéÿÿ‚ÿ‚ÿ‚ÿŒÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ°ÿÿÜÿ ÿÿÿÿ©ÿÿÿ÷ÿýÿðÿÿÿõÿ ÿÿÿÿøÿÿÿÿÿÿÿÿîÿÿÿñÿÿÿîÿÿÿñÿÿòÿÿÿíÿÿÿâÿ ÿÿÿÿÜÿÿÿýÿÿÿÓÿÿÓÿÿÿÙÿÿÿõÿ ÿÿÿÿ‚ÿìÿÿÿ‚ÿ‚ÿ‚ÿŒÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ³ÿÿÿÜÿ ÿÿÿÿ©ÿÿÿøÿÿÿðÿÿÿõÿ ÿÿÿÿøÿÿýÿ ÿÿÿÿîÿÿÿñÿÿÿîÿÿÿñÿÿëÿÿñÿÿßÿ ÿÿÿÙÿÿÿýÿÿÿ ÿÿÖÿÿÿõÿ ÿÿÿÿ‚ÿìÿ ÿÿÿ‚ÿ‚ÿ‚ÿÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ°ÿÿÿßÿÿýÿÿ©ÿÿÿøÿÿÿðÿÿÿõÿ ÿÿÿÿûÿÿÿýÿ ÿÿÿÿîÿÿÿñÿÿëÿÿÿñÿÿëÿÿñÿÿßÿ ÿÿÿÙÿÿÿýÿÿåÿÿÿÁÿÿâÿÿÿýÿÿÿòÿÿÿÿ‚ÿìÿ ÿÿÿ‚ÿ‚ÿ‚ÿÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ°ÿÿÿßÿÿýÿÿ˜ÿÿÿðÿÿÿõÿÿþÿ÷ÿÿÿÿÿÿÿÿÿîÿÿÿñÿÿëÿÿÿñÿÿëÿÿñÿÿÜÿÿÿÙÿÿÿýÿÿåÿÿÿÖÿÿÿôÿÿâÿÿÿýÿÿÿòÿ ÿÿÿÿ‚ÿìÿÿÿ‚ÿ‚ÿ‚ÿÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ°ÿÿÿßÿÿýÿÿÿ›ÿÿÿðÿÿïÿÿÿúÿÿÿýÿ ÿÿÿÿîÿÿÿîÿëÿÿÿÖÿÿñÿÿÜÿÿÖÿÿÿýÿÿåÿÿÿÖÿÿÿôÿÿâÿÿÿýÿÿÿòÿ ÿÿÿÿ‚ÿìÿÿÿ‚ÿ‚ÿ‚ÿÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ°ÿÿÿßÿÿýÿÿÿ›ÿÿÿðÿÿïÿÿÿúÿÿÿÞÿÿÿÖÿÿÿÖÿÿÿ÷ÿÿÿ©ÿÿýÿÿåÿÿÿÖÿÿÿôÿÿâÿÿÿýÿÿÿòÿ ÿÿÿÿ‚ÿéÿÿ‚ÿ‚ÿ‚ÿÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ­ÿÿßÿÿýÿÿÿžÿÿþÿÿÿñÿÿïÿ ÿÿÿÿþÿÿÿÞÿÿÿÖÿÿÿÖÿÿÿ÷ÿÿÿ©ÿúÿÿåÿÿÿÖÿÿÿôÿÿâÿÿÿýÿÿÿòÿ ÿÿÿÿ‚ÿéÿÿ‚ÿ‚ÿ‚ÿÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ­ÿÿâÿÿÿýÿÿÿžÿÿþÿÿÿñÿÿïÿ ÿÿÿÿþÿÿØÿÿÖÿÿÿÖÿÿÿ÷ÿÿÿ£ÿÿÿâÿÿ÷ÿÿåÿÿÿôÿÿâÿÿÿæÿÿÿ‚ÿåÿÿÿ‚ÿ‚ÿ‚ÿ’ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ­ÿÿâÿÿÿýÿÿÿžÿ ÿÿÿÿôÿÿÿïÿ ÿÿÿÿÿþÿØÿÿÖÿÿÿÖÿÿÿ÷ÿÿÿ£ÿÿÿâÿÿ÷ÿÿåÿÿÿôÿÿâÿÿÿæÿÿÿ‚ÿåÿÿÿ‚ÿ‚ÿ‚ÿ’ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¶ÿ ÿÿÿÿâÿÿÿýÿÿÿ¬ÿÿÿûÿ ÿÿÿÿôÿÿÿïÿ ÿÿÿÿþÿÿØÿÿÓÿÿÖÿÿÿ÷ÿÿÿ£ÿÿÿâÿÿ÷ÿÿåÿÿÿÐÿÿÿæÿÿþÿ‚ÿåÿÿÿ‚ÿ‚ÿ‚ÿ’ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¶ÿ ÿÿÿÿÖÿÿÿ¬ÿÿøÿ ÿÿÿÿôÿÿÿïÿ ÿÿÿÿþÿÿØÿÿÓÿÿôÿÿÿëÿÿÿ÷ÿÿÿ ÿßÿÿÿúÿÿâÿÿÍÿÿãÿÿÿ‚ÿñÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ’ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¶ÿ ÿÿÿÿÖÿÿÿ¬ÿÿøÿ ÿÿÿÿôÿÿÿîÿýÿýÿÿÿöÿÿèÿÿÿ÷ÿÿÿèÿÿôÿÿÿëÿÿÿ÷ÿÿÿ‚ÿûÿÿÿúÿÿâÿÿÍÿÿãÿÿÿ‚ÿñÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ’ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¶ÿÿÿÿÿÿ‚ÿûÿÿøÿ ÿÿÿÿÙÿý ÿÿÿÿóÿÿèÿÿÿ÷ÿÿÿèÿÿÿ÷ÿÿÿèÿÿ÷ÿÿÿ‚ÿûÿÿÿúÿÿâÿÿÿÐÿÿÿæÿÿÿ‚ÿñÿÿÿ‚ÿ‚ÿ‚ÿ‰ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¶ÿÿÿÿÿÿ‚ÿûÿÿøÿ ÿÿÿÿÙÿý ÿÿÿÿóÿÿÖÿÿÿèÿÿÿ÷ÿÿÿèÿÿ‚ÿéÿÿÿúÿÿâÿÿÿÐÿÿÿæÿÿÿ‚ÿñÿÿÿ‚ÿ‚ÿ‚ÿ‰ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¶ÿÿÿÿÿÿ‚ÿûÿÿøÿ ÿÿÿÿÙÿý ÿÿÿÿóÿÿÖÿÿÓÿÿÿèÿÿ‚ÿéÿÿÿýÿÿÿâÿÿÿÐÿ ÿÿÿÿìÿÿÿ‚ÿñÿÿÿ‚ÿ‚ÿ‚ÿ‰ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¶ÿÿÿÿÿÿ‚ÿþÿÿÿøÿ ÿÿÿÿ×ÿ ÿÿÿÿöÿÿÿÖÿÿÓÿÿåÿÿÿ‚ÿéÿÿýÿÿÿâÿÿÿúÿÿÿÜÿÿÿéÿÿÿ‚ÿñÿÿÿ‚ÿ‚ÿ‚ÿ‰ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¶ÿÿÿÿÿÿåÿÿÿÊÿÿÿâÿÿÿûÿÿþÿÏÿýÿÿÿöÿÿÿÖÿÿÓÿÿåÿÿÿ‚ÿéÿÿýÿÿÿâÿÿÿúÿÿÙÿÿæÿÿÿ‚ÿñÿÿ‚ÿ‚ÿ‚ÿ†ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¶ÿÿÿÜÿÿÿÐÿ ÿÿÿÿâÿÿÿþÿÿÿþÿÏÿýÿÿÿöÿÿÿÖÿÿÓÿÿåÿÿÿ‚ÿéÿÿýÿÿÿâÿÿÿúÿÿ¹ÿÿÿ‚ÿñÿÿ‚ÿ‚ÿ‚ÿ†ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¶ÿÿÙÿÿÿýÿÿÿÜÿ ÿÿÿÿâÿÿÿþÿÿþÿÿÏÿÿýÿóÿÿÿÖÿÿÓÿÿ‚ÿ¼ÿÿßÿÿÿúÿÿ¸ÿýÿ‚ÿñÿÿ‚ÿ‚ÿ‚ÿ†ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¶ÿÿÙÿÿÿúÿÿÜÿ ÿÿÿÿâÿÿÿûÿÿÿíÿÿÿëÿÿÿñÿÿÿâÿ÷ÿÿÖÿÿÿÙÿÿ‚ÿìÿÿÿßÿÿÿýÿÿÿ¸ÿýÿ‚ÿñÿÿýÿÿÿ‚ÿ‚ÿ‚ÿ’ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¶ÿÿÙÿÿÿúÿÿßÿÿÿÿÿÿâÿÿÿûÿÿÿíÿÿÿëÿÿÿñÿÿÿåÿÿ÷ÿÿÖÿÿÿÙÿÿÿ‚ÿïÿÿÿÓÿÿÿ¸ÿýÿÿÞÿÿÐÿÿÖÿÿÿúÿÿ‚ÿ‚ÿ‚ÿ’ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¹ÿÿÿÙÿÿ÷ÿÿßÿÿÿÿÿÿâÿÿÿûÿÿÿíÿÿÿëÿÿÿñÿÿÿåÿÿ÷ÿÿåÿÿÿúÿÿÿÙÿÿÿ‚ÿïÿÿÿÓÿÿÿ¸ÿýÿÿáÿ ÿÿÿÖÿ ÿÿÿÙÿÿÿúÿÿ‚ÿ‚ÿ‚ÿ’ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¹ÿÿÿÙÿÿ÷ÿÿßÿÿÿÿÿÿâÿÿÿûÿÿÿíÿÿèÿÿÿñÿÿÿåÿÿúÿÿÿåÿÿÿúÿÿÿÙÿÿÿ‚ÿïÿÿÿÓÿÿÿ¶ÿÿÿáÿ ÿÿÿÖÿ ÿÿÿÙÿÿÿúÿÿ‚ÿ‚ÿ‚ÿ’ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¹ÿÿÿúÿÿåÿÿ÷ÿÿßÿÿÿÿÿÿâÿýÿÿýÿÿÿÿÿÿÿ÷ÿÿèÿÿÿñÿÿÿåÿÿúÿÿÿâÿÿúÿÿÿÙÿÿ‚ÿæÿÓÿÿÿ¶ÿÿÿáÿ ÿÿÿÖÿ ÿÿÿÙÿÿÿúÿÿ‚ÿ‚ÿ‚ÿ’ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¹ÿÿÿúÿÿåÿÿ÷ÿÿÿâÿÿÿÿÿÿâÿýÿÿÿÿÿüÿÿÿ÷ÿÿèÿÿÿñÿÿÿåÿÿúÿÿÿâÿÿúÿÿÿâÿÿýÿÿ‚ÿ¶ÿÿÿ¶ÿÿÿáÿ ÿÿÿÖÿ ÿÿÿÙÿÿÿúÿÿÿ‚ÿ‚ÿ‚ÿ•ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿªÿÿèÿÿÿ÷ÿÿÿâÿÿÿÿÿÿãÿÿÿÿÿÿÿùÿÿúÿÿÿèÿÿÿñÿÿÿåÿÿÿýÿÿÿâÿÿÿýÿÿÿâÿ ÿÿÿÿ‚ÿ¶ÿÿ²ÿýÿÿÿßÿÿÐÿÿÙÿÿÿúÿÿÿÙÿ‚ÿ‚ÿ‚ÿ¿ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿªÿÿøÿóÿÿÿ÷ÿÿÿâÿÿÿýÿÿãÿÿÿÿÿÿÿùÿÿúÿÿÿÐÿÿÿåÿÿÿýÿÿÿâÿÿÿýÿÿÿâÿ ÿÿÿÿ‚ÿ¼ÿ ÿÿÿ²ÿýÿÿÿßÿÿÐÿÿÊÿÿÿßÿÿÿ‚ÿ‚ÿ‚ÿ¿ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿªÿÿûÿ ÿÿÿùÿÿÿ÷ÿÿÿâÿÿÿýÿÿãÿ ÿÿÿÿþÿöÿÿúÿÿÿÐÿÿÿåÿÿÿÖÿÿÿÖÿ ÿÿÿÿ‚ÿ¼ÿ ÿÿÿ²ÿýÿÿÿßÿÿÿÓÿÿÿÍÿÿÿßÿÿÿ‚ÿ‚ÿ‚ÿ¿ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿªÿÿûÿ ÿÿÿùÿÿÿ÷ÿÿÿâÿÿÿýÿÿãÿ ÿÿÿÿñÿÿúÿÿÿ¬ÿÿÿÖÿÿÿÖÿ ÿÿÿÿ‚ÿ¼ÿ ÿÿÿ²ÿýÿÛÿÿÿÓÿÿÿÍÿÿÿßÿ ÿÿÿ‚ÿ‚ÿ‚ÿÂÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿªÿÿÿþÿ ÿÿÿùÿÿÿ÷ÿÿÿâÿÿÿýÿÿÿæÿ ÿÿÿÿñÿÿúÿÿÿ©ÿÿÖÿÿÿÓÿÿÿ‚ÿ¶ÿÿ¯ÿýÿÛÿÿÿÓÿÿÿÍÿÿÿâÿ ÿÿÿÿ‚ÿ‚ÿ‚ÿÂÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿªÿÿÿþÿ ÿÿÿÿüÿÿÿ÷ÿÿÿâÿÿÿýÿÿÿéÿÿÿÿÿÿñÿÿúÿÿ¦ÿÿÓÿÿÐÿÿ‚ÿ‚ÿÜÿÿÿÞÿÿÿÓÿÿÿÍÿÿÿâÿ ÿÿÿÿ‚ÿ‚ÿ‚ÿÂÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿªÿÿÿþÿ ÿÿÿÿüÿÿÿ÷ÿÿÿâÿÿÿýÿÿÿéÿ ÿÿÿÿîÿÿÿýÿÿ¦ÿÿÓÿÿ‚ÿ‚ÿ¦ÿÿÿÞÿÿÿÜÿÿÿÿÿÿÍÿÿÿâÿ ÿÿÿÿ‚ÿ‚ÿ‚ÿÂÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¹ÿÿ÷ÿÿÿýÿÿÿÿÿùÿÿôÿÿâÿÿúÿÿæÿ ÿÿÿÿîÿÿÿýÿÿâÿÿÊÿÿÿÖÿÿÿ‚ÿ‚ÿ©ÿÿÿçÿÿÿýÿÿÜÿÿÿýÿÿÍÿÿÿâÿÿÿ‚ÿ‚ÿ‚ÿ¼ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¹ÿÿ÷ÿÿÿýÿÿÿÿÿçÿÿ¶ÿÿÿÿëÿÿÿýÿÿâÿÿÊÿÿÿÖÿ ÿÿÿ‚ÿ‚ÿ¬ÿÿÿçÿÿÿÓÿÿÿýÿÿÜÿÿÿúÿÿÿâÿÿÿ‚ÿ‚ÿ‚ÿ¼ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¹ÿÿ÷ÿÿÿýÿÿýÿÿÿšÿÿÿÿëÿÿÿýÿÿâÿÿÿ÷ÿÿÿÜÿÿÿÙÿ ÿÿÿ‚ÿ‚ÿ¬ÿ ÿÿÿÿëÿÿÿÓÿÿÿÓÿÿÿúÿÿÿâÿÿÿ‚ÿ‚ÿ‚ÿ¼ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¹ÿÿ÷ÿÿÿýÿúÿÿÿ¦ÿúÿÿþÿÿÿèÿÿúÿâÿÿÿ÷ÿÿÿÜÿÿÿÖÿÿÿ‚ÿ‚ÿ©ÿÿÿÿëÿÿÿÓÿÿÿÓÿÿÿÓÿÿÿ‚ÿ‚ÿ‚ÿ¼ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿ¹ÿÿôÿþÿþ ÿÿÿÿþÿÿ©ÿÿÿÿÿÿÿÿÿèÿÿÿÜÿÿÿ÷ÿÿÿ‚ÿ‚ÿ‚ÿÈÿ ÿÿÿÿîÿÿÿÓÿÿÿÓÿÿÐÿÿÿ‚ÿ‚ÿ‚ÿ¼ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿàÿÿÿïÿÿùÿÿôÿý ÿÿÿÿûÿ ÿÿÿ¯ÿÿÿÿÿÿÿÿÿèÿÿÿÜÿÿÿ÷ÿÿÿ‚ÿ‚ÿ‚ÿÊÿý ÿÿÿÿîÿÿÿÓÿÿÿÓÿýÿÿÕÿÿÿ‚ÿ‚ÿ‚ÿ¼ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿàÿÿÿòÿ ÿÿÿüÿÿõÿÿþÿÿôÿ ÿÿÿµÿÿÿÿÿÿÿÿÿÿèÿÿÙÿÿÿ÷ÿÿ‚ÿ‚ÿ‚ÿÇÿý ÿÿÿÿîÿÿÿÓÿÿÿÓÿýÿÿÿ‚ÿ‚ÿ‚ÿ‹ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿàÿÿÿòÿ ÿÿÿüÿÿõÿÿþÿÿñÿÿÿñÿÿÿêÿôÿÿÿûÿÿÿÿÿÿÿÿÿÿ»ÿÿÿ÷ÿÿ‚ÿ‚ÿ‚ÿÇÿý ÿÿÿÿîÿÿÐÿÿÿÖÿÿýÿÿÿÏÿÿÿ‚ÿ‚ÿ‚ÿÅÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿàÿÿÿòÿÿÿÿÿÿÿÿøÿÿÿþÿÿñÿÿÿôÿ ÿÿÿêÿÿÿúÿÿÿûÿÿÿýÿÿÿÿÿÿ¸ÿÿ÷ÿÿ‚ÿ‚ÿ‚ÿÇÿý ÿÿÿÿîÿÿúÿÿÿßÿÿúÿÿÿâÿÿýÿÿÿÏÿÿÿ‚ÿ‚ÿ‚ÿÅÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿàÿ ÿÿÿÿøÿÿÿÿÿÿÿÿøÿÿÿþÿÿðÿýÿôÿ ÿÿÿÿíÿÿÿ÷ÿÿûÿÿÿöÿÿÿ¸ÿÿ÷ÿÿ‚ÿ‚ÿ‚ÿÇÿý ÿÿÿÿÿôÿÿÿúÿÿÿßÿÿúÿÿÿâÿýÿÿÿÿÿÿÿÿÙÿÿÿÿ‚ÿ‚ÿ¬ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿàÿ ÿÿÿÿûÿÿÿÿÿÿÿÿÿûÿÿÿÿþÿÿñÿÿþÿÿ÷ÿ ÿÿÿÿíÿÿÿ÷ÿÿûÿ ÿÿÿÿúÿÿÿ¸ÿÿ÷ÿÿ‚ÿ‚ÿ‚ÿÇÿÿý ÿÿÿÿôÿÿÿúÿÿÿßÿÿúÿÿÿâÿýÿÿÿÿÿÿÿÿÿÜÿÿÿ£ÿÿÿ‚ÿ‚ÿ¬ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿàÿ ÿÿÿÿûÿÿÿýÿ ÿÿÿÿûÿÿÿÿþÿðÿþÿþÿÿ÷ÿ ÿÿÿÿíÿÿÿ÷ÿÿþÿ ÿÿÿÿ÷ÿÿÿ¸ÿÿúÿÿÿ‚ÿ‚ÿ‚ÿÇÿÿý ÿÿÿÿöÿÿÿúÿÿÿâÿÿÿúÿÿÿâÿýÿÿÿÿÿÿÿÿÿÜÿÿÿ£ÿÿÿ‚ÿ‚ÿ¬ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿàÿ ÿÿÿÿþÿÿþÿÿýÿ ÿÿÿÿûÿÿÿÿþÿðÿÿýÿÿúÿÿÿÿÿÿíÿÿÿ÷ÿÿÿý ÿÿÿÿ÷ÿÿµÿÿúÿÿÿ‚ÿ‚ÿ‚ÿÇÿÿý ÿÿÿÿöÿÿÿúÿÿÿâÿÿÿúÿÿÿâÿýÿÿÿÿþ ÿÿÿÿÿèÿÿúÿÿÿ£ÿ ÿÿÿ‚ÿ‚ÿ¯ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿàÿÿýÿÿþÿÿþÿÿýÿÿÿÿÿÿúÿÿÿðÿÿýÿÿúÿ ÿÿÿÿýÿÿðÿÿÿ÷ÿÿÿýÿÿóÿÿµÿÿÿýÿÿÿ‚ÿ‚ÿ‚ÿÇÿÿÿý ÿÿÿÿùÿÿÿúÿÿÿâÿÿÿúÿÿÿâÿýÿÿÿÿþÿÿÿÿÿÿëÿÿÿúÿÿ¦ÿÿÿ‚ÿ‚ÿ©ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿãÿÿÿýÿÿþÿÿþÿÿÿûÿ ÿÿÿÿúÿÿÿðÿÿÿýÿúÿ ÿÿÿÿýÿÿðÿÿÿ÷ÿÿÿýÿÿóÿÿµÿÿÿýÿÿÿ‚ÿ‚ÿ‚ÿÇÿÿÿûÿÿÿùÿÿÿ÷ÿÿâÿÿÿúÿÿÿâÿýÿÿýÿÿÿÿÿÿÿëÿÿÿúÿÿ¦ÿÿÿ‚ÿ‚ÿ©ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿãÿÿÿýÿþÿÿþÿÿöÿý ÿÿÿÿýÿÿÿðÿÿÿýÿÿÿÿÿÿÿÿýÿÿÿÿÿÿüÿÿôÿÿÿýÿÿóÿÿµÿÿÿýÿÿ‚ÿ‚ÿ‚ÿÄÿÿÿøÿÿÿüÿÿÿ÷ÿÿâÿÿÿ÷ÿÿãÿÿÿúÿ ÿÿÿÿýÿêÿÿ÷ÿÿ¦ÿÿÿ‚ÿ‚ÿ©ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿãÿÿÿýÿþÿÿþÿÿîÿÿÿýÿÿÿðÿÿÿýÿÿÿÿÿÿÿÿþÿÿÿÿÿÿüÿÿôÿÿÿýÿÿ™ÿÿÿ‚ÿ‚ÿ‚ÿÄÿÿÿøÿÿÿêÿÿÐÿÿãÿÿÿúÿÿÿÿÿÿÿíÿÿ÷ÿÿÿ©ÿÿÿ‚ÿ‚ÿ©ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿãÿÿÿýÿþÿÿþÿÿîÿÿÿýÿÿÿðÿÿÿþÿÿÿÿÿÿÿÿþÿÿÿÿÿÿüÿÿôÿÿÿýÿÿ™ÿÿÿ‚ÿ‚ÿ‚ÿÄÿÿÿøÿÿÿêÿÿÿÓÿÿãÿÿÿ÷ÿÿÿÿÿÿÿðÿÿ÷ÿÿÿ©ÿÿÿ‚ÿ‚ÿ©ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿãÿÿÿýÿþÿÿþÿÿñÿÿþÿÿÿÿÿÿÿñÿÿûÿÿÿÿÿÿÿÿûÿÿÿÿþ ÿÿÿÿÿòÿÿÿþÿÿ‚ÿ‚ÿ‚ÿÄÿÿÿøÿÿÿêÿÿÿÓÿÿÿæÿÿÿ÷ÿÿÿÿÿÿÿðÿÿ÷ÿÿÿ©ÿÿÿ‚ÿ‚ÿ©ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿãÿÿÿþÿÿÿÿþÿÿôÿÿÿÿþÿÿÿÿÿÿñÿÿûÿ ÿÿÿüÿÿûÿÿûÿÿÿÿÿÿòÿÿþÿÿ‚ÿ‚ÿ‚ÿ‚ÿÍÿÿõÿÿêÿÿÿÓÿÿÿæÿÿñÿÿÿÿÿÿðÿÿ÷ÿÿÿ©ÿ ÿÿÿÿ‚ÿ‚ÿ¯ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿãÿÿÿþÿÿÿÿþÿÿôÿÿÿûÿÿÿÿÿÿñÿÿøÿÿÿüÿÿïÿ ÿÿÿÿòÿÿþÿÿ‚ÿ‚ÿ‚ÿ‚ÿÍÿÿøÿÿþÿÿíÿÿÿÓÿÿÿæÿÿÿÿñÿÿþÿÿÿóÿÿ÷ÿÿÿ©ÿÿÿÿÿÿ‚ÿ‚ÿ²ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿÔÿÿýÿñÿÿøÿÿÿÿÿÿñÿÿøÿÿùÿÿïÿ ÿÿÿÿõÿÿÿþÿÿ‚ÿ‚ÿ‚ÿ‚ÿÍÿõÿÿþÿÿíÿÿÿÓÿÿÿæÿÿíÿÿþÿÿÿóÿÿ÷ÿÿÿ©ÿÿýÿÿÿ‚ÿ‚ÿ²ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿÔÿýÿÿöÿèÿÿÿôÿÿëÿÿïÿ ÿÿÿÿõÿÿÿþÿ‚ÿ‚ÿ‚ÿ‚ÿ¼ÿÿþÿÿíÿÿÿéÿÿÿóÿÿÿéÿÿÿíÿÿþÿÿÿöÿÿÿ÷ÿÿÿÜÿÿÿÖÿÿýÿÿÿ‚ÿ‚ÿ²ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿÔÿýÿÿöÿÿÿîÿÿÿÙÿÿïÿ ÿÿÿÿøÿÿÿÿþÿðÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿÒÿÿÿÿÿÿôÿÿÿìÿ ÿÿÿóÿÿÿéÿÿÿíÿÿþÿÿÿöÿÿÿÍÿÿÿÓÿÿýÿÿÿ‚ÿ‚ÿ²ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿÔÿýÿÿöÿÿÿîÿÿÿÙÿÿïÿÿÿôÿÿÿþÿÿðÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿÏÿ ÿÿÿÿýÿÿßÿ ÿÿÿóÿãÿÿÿÿîÿÿþÿÿÿöÿÿÿÍÿÿÿÖÿÿÿýÿÿÿ‚ÿ‚ÿ²ÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿÒÿÿÿöÿÿÿîÿÿÿÈÿÿÿÿþÿ÷ÿÿÿÿþÿÿðÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿÏÿÿÿÿÿÿÿâÿÿÿÿÿÿÙÿ ÿÿÿÿîÿÿûÿÿÿúÿÿÿÿÍÿÿÿÊÿÿÿÙÿ‚ÿ‚ÿÜÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿÒÿÿÿöÿÿÿîÿÿÿÅÿÿÿþÿúÿÿÿÿÿÿÿðÿÿ‚ÿ‚ÿ‚ÿ‚ÿÌÿÿÿÿÿÿÿÿåÿÿÿÿÿÿÜÿÿÿÿÿÿãÿÿÿýÿ ÿÿÿÿÍÿ ÿÿÿÿÍÿÿÜÿÿÿ‚ÿ‚ÿßÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ‚ÿÛÿÿÿþÿÿóÿÿÿîÿÿÿÅÿÿÿþÿÿýÿÿÿÿÿÿíÿÿ‚ÿ‚ÿ‚ÿ‚ÿÉÿÿÿÿÿÿÿåÿ ÿÿÿÿýÿßÿÿÿÿÿÿÿãÿÿÿÿÿÿÿÿÌÿ ÿÿÿÿÍÿÿÜÿÿÿ‚ÿ‚ÿßÿû‚ÿíÿø‚ÿ‚ÿ‚ÿ—ÿÐÿÿþÿÿÿþÿÿóÿÿÿîÿÿÿ¿ÿÿÿÿÿÿÿÿÿÿðÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿàÿÿÿòÿ ÿÿÿÿþÿÿèÿ ÿÿÿÿþÿþÿÿýÿ ÿÿÿñÿÿÿÿÿÿÿàÿÿÿÿÿÿÿÌÿÿÿÿÿÿÐÿÿÜÿ ÿÿÿ‚ÿ‚ÿâÿû‚ÿíÿø‚ÿ‚ÿ‚ÿšÿÿÿÖÿÿÿþÿÿÿþÿðÿÿÿîÿÿÿ¼ÿ ÿÿÿÿäÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿàÿÿÿñÿþ ÿÿÿÿþÿÿÿÿÿÿþÿÿýÿ ÿÿÿÿþÿþÿÿýÿ ÿÿÿôÿÿÿÿÿÿÿÿàÿ ÿÿÿýÿÿóÿÿßÿÿÿÿÿÿÐÿÿÿâÿ ÿÿÿÿ‚ÿ‚ÿâÿû‚ÿíÿø‚ÿ‚ÿ‚ÿšÿÿÿÖÿÿÿûÿÿÿðÿÿëÿÿÿ÷ÿÿËÿ ÿÿÿóÿÿôÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿÝÿÿñÿÿþÿÿÿþ ÿÿÿÿÿþÿÿÿÿÿÿÿÿÿÿýÿÿÿÿÿÿÿôÿÿÿÿÿÿÿÿÝÿ ÿÿÿÿþÿÿöÿÿßÿÿÿÿÿÿÐÿÿÿÜÿÿÿ‚ÿ‚ÿâÿû‚ÿíÿø‚ÿ‚ÿ‚ÿšÿ ÿÿÿÙÿÿÿûÿÿÿðÿÿÙÿÿÐÿÿýÿÿðÿÿôÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿÝÿÿñÿÿûÿÿþ ÿÿÿÿÿþÿÿÿÿÿÿÿÿÿÿÿýÿÿÿÿÿÿÿ÷ÿÿÿÿÿÿÿ×ÿÿÿÿþÿÿ÷ÿÿÿßÿÿýÿÿÿßÿÿ÷ÿÿÿÜÿÿÿ‚ÿ‚ÿâÿû‚ÿíÿø‚ÿ‚ÿ‚ÿšÿ ÿÿÿÙÿÿÿþÿÿÿÿÿÿ÷ÿÿÿÙÿÿåÿÿñÿÿÿëÿÿôÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿÝÿÿÿ÷ÿÿÿõÿÿÿÿÿÿýÿ ÿÿÿüÿÿþÿ ÿÿÿýÿÿÿúÿÿþÿÿÿýÿÿèÿÿòÿÿÿÿþÿÿÿÿþ ÿÿÿÿåÿÿÿýÿÿÿßÿÿ÷ÿÿÿÜÿÿÿ‚ÿ‚ÿâÿû‚ÿíÿø‚ÿ‚ÿ‚ÿÿ ÿÿÿÿÙÿÿÿþÿÿÿÿÿÿ÷ÿÿÿÙÿÿåÿÿÿôÿÿÿëÿÿôÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿÝÿÿÿ÷ÿÿÿõÿÿÿÿÿÿúÿÿùÿÿûÿÿúÿÿþÿÿÿÿþÿÿùÿÿèÿÿìÿÿþÿÿÿÿÿÿÿäÿÿÿúÿÿßÿÿ÷ÿÿÿÙÿÿ‚ÿ‚ÿâÿû‚ÿíÿø‚ÿ‚ÿ‚ÿÿ ÿÿÿÿÙÿÿÿþÿÿÿÿÿÿÿúÿÿÿÜÿÿÿåÿÿÿôÿÿÿëÿÿôÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿÝÿÿÿ÷ÿÿÿõÿ ÿÿÿÿêÿÿîÿýÿÿÿÿþÿÿùÿÿèÿÿéÿÿÿÿÿÿÿÿäÿÿÿúÿÿßÿÿ÷ÿÿÿÙÿÿ‚ÿ‚ÿâÿû‚ÿíÿø‚ÿ‚ÿýÿÿ‚ÿ¤ÿ ÿÿÿÿÙÿÿþÿÿÿüÿÿÿúÿÿÿÜÿÿÿåÿÿÿôÿÿÿëÿÿÿ÷ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿÝÿÿÿ÷ÿÿÿòÿ ÿÿÿêÿÿîÿýÿÿÿÿÿöÿÿèÿÿñÿÿÿýÿÿÿÿÿÿÿäÿÿÿúÿÿÿâÿÿ÷ÿÿÿÙÿÿÿ‚ÿ‚ÿåÿû‚ÿíÿø‚ÿ‚ÿÿÿÿ‚ÿ¦ÿÿÿÓÿÿþÿþÿÿüÿÿÿúÿÿÿÜÿÿÿåÿÿÿôÿÿèÿÿÿ÷ÿÿ‚ÿ‚ÿ‚ÿ‚ÿÚÿÿÿ÷ÿÿïÿ ÿÿÿÿëÿÿîÿýÿÿÿÿÿöÿÿèÿÿñÿÿÿþÿ ÿÿÿÿÿýÿÿçÿÿÿúÿÿÿåÿÿÿÐÿúÿÿÿ‚ÿ‚ÿåÿû‚ÿíÿø‚ÿ„ÿÿÿÿÿÿ‚ÿªÿÿÐÿÿþÿþÿÿüÿÿÿúÿÿÿåÿÿýÿÿâÿÿÿôÿÿèÿÿÿúÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ×ÿÿúÿÿÿèÿÿëÿÿëÿý ÿÿÿÿùÿÿÿèÿÿñÿÿÿñÿýÿÿçÿÿ÷ÿÿÿåÿÿÿÓÿÿÿýÿÿÿ‚ÿ‚ÿåÿû‚ÿíÿø‚ÿ„ÿ ÿÿÿÿ‚ÿ¬ÿÿÿÓÿÿÿþÿþÿÿüÿÿÿúÿÿÿåÿ ÿÿÿÿâÿÿÿôÿÿåÿÿúÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ×ÿÿÿýÿÿÿèÿÿÐÿýÿÿÿöÿÿÿèÿÿÿôÿÿÿñÿýÿÿØÿÿÿåÿÿÿÓÿÿÿýÿÿÿ‚ÿ‚ÿåÿû‚ÿíÿø‚ÿ„ÿ ÿÿÿÿîÿÿ‚ÿÄÿÿÿÓÿÿÿþÿþÿÿüÿÿÿÖÿ ÿÿÿÿâÿÿÿôÿÿåÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿËÿÿÿÜÿÿÐÿÿýÿÿöÿÿÿèÿÿÿôÿÿîÿÿýÿØÿÿÿåÿÿÿÓÿÿÿýÿÿÿ‚ÿ‚ÿåÿû‚ÿíÿø‚ÿ†ÿý ÿÿÿÿñÿ ÿÿÿ‚ÿ‘ÿÿÿþÿþÿöÿÿÖÿ ÿÿÿÿâÿÿÿôÿÿåÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿËÿÿÿÜÿÿÐÿÿÍÿÿÿôÿÿîÿÿýÿýÿÿßÿÿÿåÿÿÿÓÿÿÿÍÿÿÿ‚ÿ–ÿû‚ÿíÿø‚ÿ‡ÿÿÿÿÿÿñÿ ÿÿÿ‚ÿ‘ÿÿÿýÿÿöÿÿÿÖÿÿÿÜÿÿ÷ÿÿÿåÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿËÿÿÿÜÿÿÿÓÿÿÍÿÿÿ÷ÿÿÿëÿý ÿÿÿÿÿâÿÿÿæÿÿÿÒÿÿÿÍÿÿÿ‚ÿ–ÿû‚ÿíÿø‚ÿ‡ÿÿÿÿÿÿôÿ ÿÿÿÿ‚ÿ»ÿÿÿßÿÿþÿþÿÿöÿÿÿ©ÿÿÿúÿÿÿåÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿÈÿÿÿßÿÿÿÓÿÿÿÍÿÿ÷ÿÿÿëÿý ÿÿÿÿÿÂÿ ÿÿÿúÿÿþÿÿÿçÿÿÊÿÿÿ‚ÿ–ÿû‚ÿíÿø‚ÿ‡ÿÿÿýÿÿÿÿøÿ ÿÿÿÿ‚ÿ»ÿÿÿßÿÿþÿþÿÿöÿÿÿ©ÿÿÿúÿÿÿâÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿËÿÿÜÿÿÿÓÿÿÿÍÿÿÿúÿÿÿëÿÿýÿúÿÇÿÿÿÿÿÿÿÿÿþ ÿÿÿÿÿëÿÿÇÿÿÿ‚ÿ™ÿû‚ÿíÿø‚ÿ‡ÿÿÿýÿÿÿ÷ÿ ÿÿÿÿ‚ÿ¸ÿÿÚÿÿþÿóÿÿÿ©ÿÿÿúÿÿßÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ¡ÿÿÿÓÿÿÿÍÿÿÿúÿÿÿëÿÿýÿÿÿÿÿÊÿÿÿÿÿÿÿÿþÿÿÿÿÿÿÿîÿÿÇÿÿÿ‚ÿ™ÿû‚ÿíÿø‚ÿ‡ÿÿÿýÿÿÿ÷ÿÿÿÿþÿÿ‚ÿ»ÿÿÚÿÿþÿðÿ ÿÿÿ¯ÿÿÿýÿÿÿßÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿžÿÿôÿÿÿèÿÿÿÍÿÿÿúÿÿÿëÿÿýÿÿÿÿÿÿüÿÿÿÚÿ ÿÿÿÿýÿÿÿÿÿÿÿÿÿÿÿþÿÿÿüÿÿÇÿÿÿ‚ÿ™ÿû‚ÿíÿø‚ÿ‡ÿÿÿýÿÿÿúÿ ÿÿÿÿþÿÿ‚ÿÊÿÿÿúÿÿÿÝÿÿÿðÿÿÿ¬ÿÿÿúÿÿÙÿ‚ÿ‚ÿ‚ÿ‚ÿžÿÿôÿÿÿåÿÿôÿÿÿâÿÿÿúÿÿÿãÿÿÿýÿÿÿÿÿÿÿÝÿ ÿÿÿÿÿýÿÿÿÿÿÿÿýÿÿÿþÿÿÿÿÿÿÿÿ÷ÿÿÿÙÿÿÿ‚ÿ™ÿû‚ÿíÿø‚ÿ‡ÿÿúÿ ÿÿÿÿþÿ ÿÿÿÿþÿÿ‚ÿÊÿÿ÷ÿÿÿÝÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿØÿÿÿÓÿÿÿâÿÿÿúÿÿÔÿÿÿÿÿÿÿýÿîÿ ÿÿÿÿþÿÿ÷ÿÿÿÿÿÿÿýÿÿÿÿÿÿÿÿÿÿÿ÷ÿÿÿÙÿÿÿÙÿÿÿ‚ÿÉÿû‚ÿíÿø‚ÿ‡ÿÿúÿ ÿÿÿÿþÿ ÿÿÿÿþ ÿÿÿÿ‚ÿÎÿÿ÷ÿÿÿÝÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÒÿÿÿÓÿÿÿâÿÿÿýÿÿÿÔÿ ÿÿÿÿÿýÿÿÿôÿÿÿÿÿÿÿÿ÷ÿÿÿüÿÿýÿÿÿÿÿÿÿÿÿÿÿ÷ÿÿÿÖÿÿÙÿ ÿÿÿ‚ÿÌÿû‚ÿíÿø‚ÿ‰ÿýÿ÷ÿÿÿÿþÿ ÿÿÿÿþ ÿÿÿÿ‚ÿÑÿÿÿûÿ ÿÿÿÿÝÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÛÿÿÿÓÿÿÿÖÿÿÿÔÿÿþÿÿÿÿýÿÿÿÿÿÿÿÿýÿÿÿÿÿÿçÿÿÿýÿÿÿýÿÿÿÿÿÿ÷ÿÿÿâÿÿÿýÿÿÿÜÿ ÿÿÿ‚ÿÌÿû‚ÿíÿø‚ÿŠÿÿÿ÷ÿÿÿýÿÿÿÿþÿ ÿÿÿÿ‚ÿÑÿÿýÿÿÿÿÿÿÿåÿÿÿýÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÞÿÿÿÐÿÿÓÿÿÿÔÿÿþÿÿÿÿÿÿÿÿÿÿÿýÿÿýÿÿÿáÿÿýÿÿÿúÿ ÿÿÿÿôÿÿâÿÿÿýÿÿÿÜÿ ÿÿÿ‚ÿÌÿû‚ÿíÿø‚ÿŠÿÿÿ÷ÿÿÿÿÿÿÿÿþÿ ÿÿÿÿ‚ÿÑÿýÿÿÿýÿÿÿÿåÿÿýÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÞÿÿÿÓÿÿÿ›ÿÿÿÿÿÿÿÿþÿÿÿÿýÿÿÕÿÿïÿ ÿÿÿÿôÿÿâÿÿÿýÿÿÿßÿ ÿÿÿÿ‚ÿÌÿû‚ÿíÿø‚ÿŠÿÿÿöÿýÿÿÿÿÿÿûÿÿÿÿ‚ÿÑÿýÿÿÿÿÿÿÿÿéÿ ÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÛÿÿÿÓÿÿÿ¯ÿÿïÿÿÿÿÿÿÿþÿÿÿÿýÿÒÿÿÿòÿ ÿÿÿýÿùÿÿÿåÿÿúÿÿÿßÿÿÿÿÿÿ‚ÿÏÿû‚ÿíÿø‚ÿŠÿÿÿôÿÿÿÿÿÿÿûÿÿÿÿ‚ÿÒÿÿÿÿÿÿÿÿÿÿìÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿäÿÿýÿÿÿÙÿýÿÿÿ¯ÿÿÿñÿý ÿÿÿÿÿþÿÿÿÿÿÒÿÿÿòÿÿþÿÿÿÿÿüÿÿÿåÿÿúÿÿÿßÿÿÿÿÿÿ‚ÿÏÿû‚ÿíÿø‚ÿŠÿÿÿôÿÿÿÿÿÿøÿÿÿ‚ÿÑÿÿÿÿÿÿüÿÿìÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿèÿÿÿÿÿÿÜÿÿÿýÿÿÿ¯ÿÿÿñÿÿÿõÿ ÿÿÿÿðÿÿÿëÿÿÿïÿÿþÿÿÿÿÿÿÿÿÿåÿÿ÷ÿÿßÿÿýÿÿÿ‚ÿÏÿû‚ÿíÿø‚ÿŠÿÿÿñÿ ÿÿÿÿøÿÿÿ‚ÿÑÿÿÿýÿÿüÿÿÿþÿ÷ÿ ÿÿÿÿþÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿåÿ ÿÿÿÿÜÿÿÿÿÿÿ¬ÿÿÿñÿÿÿõÿÿÿÿÿÿñÿÿÿëÿÿÿìÿÿÿÿÿÿÿÿÿÿåÿÿ÷ÿÿßÿÿ‚ÿÃÿû‚ÿíÿø‚ÿŠÿÿÿÜÿÿÿ‚ÿÔÿ ÿÿÿÿÿþ ÿÿÿÿÿý ÿÿÿÿýÿ ÿÿÿÿþÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿâÿ ÿÿÿÖÿ ÿÿÿÿ¬ÿÿÿñÿÿëÿÿÿñÿÿÿèÿÿàÿÿÿÿÿÿÿþÿðÿÿÿÐÿÿ‚ÿÃÿû‚ÿíÿø‚ÿŠÿÿÿÙÿÿ‚ÿ÷ÿàÿ ÿÿÿÿÿþ ÿÿÿÿÿýÿÿÿÿÿÿÿüÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿßÿÿÿÖÿ ÿÿÿ¦ÿÿôÿÿÿëÿÿÿñÿÿÿèÿÿàÿÿÿÿÿÿÿþÿÿóÿÿÿ‚ÿÿû‚ÿíÿø‚ÿŠÿÿÖÿÿÿÿ‚ÿþÿ ÿÿÿæÿ ÿÿÿÿþÿ%ÿÿÿÿÿÿÿÿÿÿÿÿüÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¦ÿÿ£ÿÿôÿÿÿëÿÿÿñÿÿÿèÿÚÿ ÿÿÿÿþ ÿÿÿÿöÿÿÿ‚ÿÿû‚ÿíÿø‚ÿŠÿÿÖÿÿÿÿ‚ÿþÿ ÿÿÿæÿ ÿÿÿÿûÿÿÿÿÿÿÿÿþÿÿÿùÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÂÿÿôÿÿÿèÿÿñÿÿÿÓÿÿòÿÿÿÿÿÿÿÿÿÿùÿÿÿ‚ÿÿû‚ÿíÿø‚ÿÿÿÿÖÿÿÿÿ‚ÿþÿ ÿÿÿÿìÿ ÿÿÿÿøÿÿÿÿÿÿÿÿÿôÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÂÿÿÿ÷ÿÿÿèÿÿñÿÿÓÿÿÿïÿÿÿÿÿÿÿþÿÿùÿÿ‚ÿŠÿû‚ÿíÿø‚ÿÿÿÿÖÿÿ‚ÿôÿÿÿïÿÿÿÿÿÿõÿ ÿÿÿýÿÿÿÿ÷ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÂÿÿÿÖÿÿôÿÿÿÓÿÿÿïÿ ÿÿÿúÿÿÿÿÿÿÿÿÀÿÿ‚ÿÒÿû‚ÿíÿø‚ÿÿÿÿÖÿÿÿ‚ÿ÷ÿÿÿïÿÿÿÿÿÿõÿÿÿúÿÿÿÿûÿ ÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¿ÿÿÖÿÿÿ÷ÿÿÿÓÿÿÿìÿÿÿ÷ÿÿÿÿÿÿÿðÿïÿÿÿðÿÿÿ‚ÿÒÿû‚ÿíÿø‚ÿÿÿÿÖÿÿÿ‚ÿ÷ÿÿÿïÿ ÿÿÿÿàÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¼ÿÿÿÙÿÿÿ÷ÿÿÿÓÿÿÿ×ÿÿÿÿÿÿÿöÿýÿñÿ ÿÿÿóÿÿÿ‚ÿÒÿû‚ÿíÿø‚ÿÿÿÿÖÿÿÿ‚ÿ÷ÿÿÿòÿÿÿÿÿÿÝÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¼ÿÿÿÖÿÿ÷ÿÿÿÓÿÿÿÔÿ ÿÿÿÿýÿ÷ÿ ÿÿÿ÷ÿÿÿÿÿÿóÿÿ‚ÿÒÿû‚ÿíÿø‚ÿÿÿÿÿÔÿÿ‚ÿôÿÿÿõÿ ÿÿÿÿèÿÿÿîÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¼ÿ ÿÿÿÊÿÿßÿÿÿýÿÿÿÅÿÿÿýÿ ÿÿÿÿúÿ ÿÿÿÿþÿÿóÿÿÙÿÿÿƒÿû‚ÿíÿø‚ÿÿÿÐÿÿ‚ÿôÿÿÿõÿ ÿÿÿÿèÿÿÿîÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¹ÿÿÿÍÿÿÿßÿÿÿýÿÿÿÅÿÿÿÿÿÿÿÿÿÿýÿ ÿÿÿÿþ ÿÿÿÿ÷ÿÿÜÿ ÿÿÿƒÿû‚ÿíÿø‚ÿÿÿÐÿÿÿÿ‚ÿøÿÿÿøÿ ÿÿÿÿâÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¡ÿÿÿÍÿÿÿÜÿÿÿÿÿÿÂÿÿÿÿÿÿÿýÿÿÿÿÿÿÿÿÿþÿÿÿÿÿÿÿÿÜÿ ÿÿÿƒÿû‚ÿíÿø‚ÿÿÿÐÿ ÿÿÿÿ‹ÿÿÿ÷ÿÿøÿÿÿÞÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿêÿÿÿÙÿ ÿÿÿÿ¼ÿÿÿÿÿÿÿý ÿÿÿÿùÿÿýÿÿÿÿÿÿÿÿßÿ ÿÿÿÿ†ÿû‚ÿíÿø‚ÿÿÿÿÐÿ ÿÿÿÿ‹ÿÿÿ÷ÿþÿøÿÿüÿÿÿèÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿçÿÿÖÿ ÿÿÿâÿÿÿÖÿÿþÿ ÿÿÿùÿÿûÿÿþ ÿÿÿÿÿâÿÿÿÿÿÿÓÿÿ¹ÿû‚ÿíÿø‚ÿÿÿÿÐÿ ÿÿÿÿ‹ÿÿÿøÿÿÿÿþÿÿÿüÿÿÿèÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿÿÿÖÿÿÿñÿÿÿøÿÿÿÿÿÿâÿÿÿÿÿÿÖÿ ÿÿÿ¼ÿû‚ÿíÿø‚ÿÿÿÿÐÿ ÿÿÿÿÿ ÿÿÿÿýÿÿÿÿÿÿþÿÿÿüÿÿåÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿŠÿÿÖÿÿÿñÿÿÿõÿ ÿÿÿÿâÿÿýÿÿÿÖÿ ÿÿÿ¼ÿû‚ÿíÿø‚ÿÿÿÿÍÿÿÿ‘ÿÿÿÿÿÿÿÿÿÿúÿÿüÿÿÿâÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿÿÿ÷ÿÿèÿÿÿñÿÿÿõÿÿÿÿÿÿÙÿÿÖÿÿÿ¹ÿû‚ÿíÿø‚ÿÿÿÿÿÎÿ ÿÿÿÿ•ÿ(ÿÿÿÿÿÿÿÿÿÿÿÿÿüÿÿÿâÿÿÿýÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ™ÿÿÿúÿÿÿèÿÿÿñÿÿÿòÿ ÿÿÿÿþÿÿáÿÿÿÜÿÿÿÐÿÿÿïÿû‚ÿíÿø‚ÿÿÿÊÿ ÿÿÿÿ˜ÿÿÿÿÿÿõÿ ÿÿÿÿùÿÿÿâÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ™ÿÿÿúÿÿÿèÿÿÿñÿÿïÿÿÿÿÿÿÿÿäÿÿÿÜÿÿÿÐÿÿúÿõÿû‚ÿíÿø‚ÿÿÿÊÿ ÿÿÿÿîÿÿ°ÿÿÿÿÿÿòÿ ÿÿÿùÿÿÿßÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ–ÿÿúÿÿâÿÿÿ÷ÿÿÿìÿÿÿÿÿÿÿÿçÿÿÿÜÿÿÿÓÿÿÿýÿÿÿøÿû‚ÿíÿø‚ÿÿÿÇÿ ÿÿÿÿôÿ ÿÿÿ¶ÿÿÿÿÿÿÿïÿÿùÿÿÿÙÿ ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ“ÿÿÿÿÿÿâÿÿÿ÷ÿÿÿëÿýÿÿÿÿþÿÿºÿÿÐÿÿÿýÿÿÿøÿû‚ÿíÿø‚ÿ“ÿÿÿÇÿ ÿÿÿÿûÿÿÿÿÿÿÿÿÓÿÿÿïÿÿÿÿÿÿÿâÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÜÿ ÿÿÿÜÿÿ÷ÿÿåÿÿûÿÿþÿÿúÿÿÉÿÿÐÿÿ÷ÿÿøÿû‚ÿíÿø‚ÿ“ÿÿÿÇÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿÖÿ ÿÿÿÿõÿÿÿÿÿÿÿëÿÿÿýÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÙÿÿÙÿ÷ÿÿÿ×ÿÿÿÿÿÿÿÿÏÿÿÿôÿßÿÿ÷ÿÿÿûÿû‚ÿíÿø‚ÿ“ÿÿÿÆÿýÿÿÿÿÿÿÿÿüÿÿÖÿÿÿÿÿÿþÿÿþÿÿÿÿÿÿÿëÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿšÿÿÔÿÿÿÿÿÿÿÿÿÿÖÿÿÿ÷ÿÿÿâÿÿ÷ÿÿÿûÿû‚ÿíÿø‚ÿ“ÿÿÀÿýÿÿÿýÿÿÿüÿÿÖÿÿÿÿÿÿþÿþÿÿÿÿÿÿÿÿèÿ ÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿäÿ ÿÿÿÿýÿÿÿÿÿÿþÿáÿÿÿ÷ÿÿÿåÿÿÿ÷ÿÿÿûÿû‚ÿíÿø‚ÿ´ÿ ÿÿÿîÿÿÿÀÿÿÿõÿÿÿÿÿÿÿÐÿÿþÿÿþÿÿùÿÿÿåÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÝÿÿÿþÿÿÿÿÿÿÿÿÿçÿÿôÿÿÿåÿÿÿ÷ÿÿÿûÿû‚ÿíÿø‚ÿ´ÿ ÿÿÿîÿÿÿ½ÿÿøÿÿþÿÿÿÿÿÿÍÿÿýÿÿöÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¹ÿÿÿûÿÿÿÿÿÿÿÿÿ÷ÿÿÿÿÿÿÿýÿÿÿÿÿÿÿûÿÿñÿÿÿôÿÿÿýÿû‚ÿíÿø‚ÿ·ÿÿÿÿÿÿñÿÿÿ½ÿÿøÿÿÿþÿÿÿÿÿÿÐÿÿýÿóÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¶ÿÿÿøÿ ÿÿÿÿÿþÿÿÿÿÿÿÿÿÿÿÿþÿÿÿÿÿÿÿÿýÿÿÿÿÿýÿÿÿÿÿÿúÿÿÿÿÿÿû‚ÿíÿø‚ÿ·ÿÿÿÿÿÿñÿÿÿ½ÿïÿÿÿÿÿÿÿÐÿýÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿµÿÿ÷ÿÿÿëÿÿþÿþoÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿû‚ÿíÿø‚ÿ·ÿÿúÿÿôÿÿÿ¦ÿ ÿÿÿÿÿþÿÿÔÿ ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿµÿÿÿúÿÿÿèÿÿÿýÿÿÿúÿ ÿÿÿÿ÷ÿÿÿÿÿÿÿþÿÿÿÿÿÿÿÿþÿÿÿÿÿÿÿýÿÿû‚ÿíÿø‚ÿºÿÿÿúÿÿÿ÷ÿÿÿ£ÿÿÿÿÿÿÿÔÿ ÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ³ÿÿÿÿÿÿåÿÿÿéÿÿñÿÿÿôÿÿÿÿÿÿûÿÿÿüÿÿÿþÿû‚ÿíÿø‚ÿºÿÿÿ÷ÿÿÿÿþÿ ÿÿÿ ÿÿÿÿÿÿÿêÿýÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¶ÿÿÿÿÿÿåÿÿÿÐÿÿÿñÿÿÿëÿÿÿù‚ÿíÿø‚ÿ½ÿÿÿôÿ ÿÿÿÿþÿÿšÿÿÿÿÿÿÿÿóÿýÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ³ÿ ÿÿÿßÿÿÿÓÿÿÿîÿÿëÿÿÿù‚ÿíÿø‚ÿ½ÿÿÿôÿÿÿÿÿÿ‘ÿÿÿÿÿÿôÿÿÿÿÿÿÿÿùÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ†ÿÿÿÓÿÿÿÐÿÿù‚ÿíÿø‚ÿ½ÿÿÿñÿ ÿÿÿÿ‹ÿÿþÿÿÿúÿ ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿæÿÿÿúÿÿßÿÿÿÓÿþÿû‚ÿíÿø‚ÿ½ÿÿÿ‚ÿìÿÿÿþÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿãÿÿÿÿÿÿÿÿâÿ ÿÿÿÑÿû‚ÿíÿø‚ÿÀÿÿÿ‚ÿèÿþÿÿÿþÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿáÿÿÿÿÿÿÜÿÿÿÑÿû‚ÿíÿø‚ÿÀÿÿÿ‚ÿëÿÿÿþÿÿÿþ ÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÛÿ ÿÿÿÖÿÿÑÿû‚ÿíÿø‚ÿÀÿÿÿ‚ÿèÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿïÿû‚ÿíÿø‚ÿÃÿÿÿ‚ÿâÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿìÿû‚ÿíÿø‚ÿÃÿÿÿ‚ÿßÿ ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿæÿû‚ÿíÿø‚ÿÆÿÿÿ‚ÿ‚ÿçÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿ‚ÿ‚ÿ¤ÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿíÿø‚ÿáÿ ÿÿÿñÿÿÿ‚ÿ‚ÿçÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿ‚ÿ‚ÿ¤ÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿíÿø‚ÿäÿÿÿÿÿÿÿýÿ ÿÿÿ‚ÿ‚ÿäÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿ‚ÿ‚ÿ¤ÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿíÿø‚ÿçÿ%ÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿäÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿ‚ÿ‚ÿ¤ÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿíÿø‚ÿçÿÿÿ÷ÿ ÿÿÿÿ‚ÿ‚ÿÞÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿ‚ÿ‚ÿ¤ÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿíÿø‚ÿêÿ ÿÿÿñÿ‚ÿ‚ÿØÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿ‚ÿ‚ÿ¤ÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿíÿø‚ÿíÿ ÿÿÿ‚ÿ‚ÿÃÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿ‚ÿ‚ÿ¤ÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿíÿø‚ÿðÿ ÿÿÿ‚ÿ‚ÿÀÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿ‚ÿ‚ÿ¤ÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿíÿø‚ÿöÿ ÿÿÿÿ‚ÿ‚ÿ½ÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿ‚ÿ‚ÿ¤ÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿíÿø‚ÿüÿÿÿÿÿÿ‚ÿ‚ÿºÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿ‚ÿ‚ÿ¤ÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿíÿø‰ÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ·ÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿ‚ÿ‚ÿ¤ÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿíÿø³ÿ=ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ±ÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿ‚ÿ‚ÿ¤ÿû‚ÿ‚ÿ‚ÿ¡ÿû‚ÿíÿ‚‚‚‚‚‚‚‚‚‚‚‚‚‚‚ã‚ÿíÿ‚‚‚‚‚‚‚‚‚‚‚‚‚‚‚ã‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿñÿõ‚ÿ‚ÿ‚ÿ¶ÿþãÿõ‚ÿ‚ÿ‚ÿÑÿòéÿò‚ÿ‚ÿ‚ÿÑÿõæÿõ‚ÿ‚ÿ‚ÿÅÿûìÿòŒÿûõÿþ‚ÿ‚ÿ‚ÿ¿ÿøéÿûõÿû‚ÿ‚ÿ‚ÿÚÿìïÿûøÿû‚ÿ‚ÿ‚ÿÚÿûûÿøïÿûõÿû‚ÿ‚ÿ‚ÿËÿûïÿûøÿûÿþòÿû‚ÿ‚ÿ‚ÿÈÿþûÿûéÿþòÿû‚ÿ‚ÿ‚ÿÝÿþòÿøõÿûòÿû‚ÿ‚ÿ‚ÿËÿûòÿûòÿþ‚ÿ‚ÿ‚ÿÎÿøòÿûòÿû•ÿûïÿû‚ÿ‚ÿ‚ÿÂÿûìÿûïÿû‚ÿ‚ÿ‚ÿãÿûïÿûõÿûòÿø‚ÿ‚ÿ‚ÿãÿþïÿûõÿûïÿû‚ÿ‚ÿ‚ÿÔÿþþÿûòÿûòÿø˜ÿûïÿû‚ÿ‚ÿ‚ÿÂÿûìÿûïÿû‚ÿ‚ÿ‚ÿãÿþìÿûøÿøòÿø‚ÿ‚ÿ‚ÿÎÿûõÿûïÿû‚ÿ‚ÿ‚ÿÔÿþþÿûòÿûòÿø›ÿøïÿû‚ÿ‚ÿ‚ÿÂÿûìÿûïÿû‚ÿ‚ÿ‚ÿËÿûøÿøòÿø‚ÿ‚ÿ‚ÿÎÿþòÿûïÿû‚ÿ‚ÿ‚ÿ×ÿþûÿûõÿøòÿø›ÿøïÿø‚ÿ‚ÿ‚ÿÅÿûïÿøïÿø‚ÿ‚ÿ‚ÿÎÿûøÿûìÿû‚ÿ‚ÿ‚ÿÑÿþòÿøïÿø‚ÿ‚ÿ‚ÿÝÿþøÿûõÿûìÿû›ÿøïÿø‚ÿ‚ÿ‚ÿÅÿûïÿøïÿø‚ÿ‚ÿ‚ÿÎÿþõÿûìÿû‚ÿ‚ÿ‚ÿÔÿøõÿøïÿø‚ÿ‚ÿ‚ÿàÿþõÿûõÿûìÿû›ÿøïÿø‚ÿ‚ÿ‚ÿÅÿûïÿøïÿø‚ÿ‚ÿ‚ÿÑÿûõÿûìÿû‚ÿ‚ÿ‚ÿÚÿïøÿøïÿø‚ÿ‚ÿ‚ÿãÿþòÿûõÿûìÿû›ÿøïÿø‚ÿ‚ÿ‚ÿÅÿûïÿøïÿø‚ÿ‚ÿ‚ÿÑÿþòÿûìÿû‚ÿ‚ÿ‚ÿÑÿøøÿøïÿø‚ÿ‚ÿ‚ÿãÿþòÿûõÿûìÿû›ÿøïÿø‚ÿ‚ÿ‚ÿÅÿûïÿøïÿø‚ÿ‚ÿ‚ÿÔÿþïÿûìÿû‚ÿ‚ÿ‚ÿÎÿøûÿøïÿø‚ÿ‚ÿ‚ÿæÿþïÿûõÿûìÿû›ÿøïÿû‚ÿ‚ÿ‚ÿÂÿûìÿûïÿû‚ÿ‚ÿ‚ÿÔÿþìÿûìÿû‚ÿ‚ÿ‚ÿËÿûøÿûïÿû‚ÿ‚ÿ‚ÿãÿàûÿûìÿû˜ÿûïÿû‚ÿ‚ÿ‚ÿÂÿûìÿûïÿû‚ÿ‚ÿ‚ÿ×ÿþéÿøòÿø‚ÿ‚ÿ‚ÿËÿûøÿûïÿû‚ÿ‚ÿ‚ÿãÿàøÿûòÿø˜ÿûïÿû‚ÿ‚ÿ‚ÿÂÿûìÿûïÿû‚ÿ‚ÿ‚ÿÚÿþæÿøòÿø‚ÿ‚ÿ‚ÿËÿþõÿûïÿû‚ÿ‚ÿ‚ÿÎÿûòÿûòÿø˜ÿûòÿû‚ÿ‚ÿ‚ÿ¿ÿûìÿûòÿû‚ÿ‚ÿ‚ÿÚÿþàÿûòÿû‚ÿ‚ÿ‚ÿÈÿþõÿøòÿþ‚ÿ‚ÿ‚ÿËÿûòÿûòÿû’ÿûõÿû‚ÿ‚ÿ‚ÿ¿ÿûéÿûõÿû‚ÿ‚ÿ‚ÿÚÿæõÿþòÿþ‚ÿ‚ÿ‚ÿÝÿûòÿþïÿûõÿû‚ÿ‚ÿ‚ÿËÿûïÿþòÿûÿûûÿû‚ÿ‚ÿ‚ÿ¿ÿõéÿûûÿû‚ÿ‚ÿ‚ÿÝÿãïÿûþÿû‚ÿ‚ÿ‚ÿÚÿõûÿþéÿûûÿû‚ÿ‚ÿ‚ÿÈÿûìÿûþÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÝÿéÎÿæéÿìûÿì‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿþÿø¹ÿòÝÿøæÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿþÿø¶ÿõÝÿûãÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿþÿø³ÿøÝÿûãÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿþÿø³ÿõàÿþàÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿøòÿõ¶ÿø³ÿõãÿûàÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿôÿøæÿø¹ÿø°ÿõæÿûàÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ÷ÿøãÿõ¼ÿøÝÿòãÿõæÿþÝÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿúÿøïÿþïÿø¿ÿøãÿûøÿøãÿõìÿûÝÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿýÿõòÿøòÿõÂÿøæÿþïÿøæÿõìÿûÝÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿýÿõòÿøòÿõÂÿøéÿûìÿøæÿøìÿþÚÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿýÿøïÿøïÿøÂÿøéÿûìÿøæÿõòÿûÚÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿýÿøïÿøïÿøÂÿøéÿÝãÿøõÿøÚÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿõïÿøïÿõÅÿøìÿûÂÿõøÿû×ÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿõïÿøïÿõÅÿøìÿøÂÿøøÿû×ÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿõïÿøïÿõÅÿøìÿøÂÿõþÿûÔÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿõïÿøïÿõÅÿøìÿøÂÿõþÿûÔÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿýÿøìÿþìÿøÂÿøìÿøãÿþàÿòÑÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿýÿøïÿøïÿøÂÿøìÿõéÿûàÿòÑÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿýÿõòÿøòÿõÂÿøéÿõïÿûÚÿõÑÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿúÿøõÿûþÿûõÿø¿ÿøéÿïøÿû×ÿøÎÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿúÿõûÿûøÿûþÿõ¼ÿøæÿæÔÿøÎÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿôÿòòÿò¹ÿøãÿìÎÿþËÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿþÿø‚ÿáÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿþÿø‚ÿáÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿþÿø‚ÿáÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿþÿø‚ÿáÿû‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿþÿõ‚ÿçÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿËÿ€ endstream endobj 95 0 obj << /Type /XObject /Subtype /Image /Name /Ma0 /Filter [/RunLengthDecode] /Width 694 /Height 492 /ColorSpace /DeviceGray /BitsPerComponent 8 /Length 97 0 R >> stream ‚‚‚‚‚Æ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ€ endstream endobj 100 0 obj << /Length 2090 /Filter /FlateDecode >> stream xÚXK㸾÷¯ðQZ‘”(ifgz’ÍÙÙnvv²LÛ$Q£Çô:‡üöT±H™v+4`‘Åb±XõÕƒoN›xóç‡øîËà7Þ° YTr“Ⱦé¦j¾=Ä‘È2^lÝNKx÷S›m>ê‡_áÏ-…Njè‰ýq÷ðîS–n²¨Èb¶Ù7,–‘HÓM’ÆQ*óÍî°ù|ªOó ¶!Ïx ؆"M‚ßã4.ᇙ¹>èn›ÄÁ÷-K5lYœTWÙMý {5Lµi®ôΖaìU5 s‹3¶,ç¦Qƒê,Ó<Ö݉†Ú°Òݨ†ï ±Õ|нžT7Õe3F Y–;wHSZ½†í×Ý_Á*a%2¥;Vó¤‘ öÈ}{ˆ(ã)ð¦ßc&,“o´,âœ]yÒ8‹áèXÏ´çQhTwôÎõH£ªlª¹)§ZÛ¥A}›ëAÙå’>žþ0Ï‚nn÷4–ÆdFö¤#ÇIÖm_îd¸¢=YY¥ši(G}œhzgAc&NT$’Œ•Xcùúò6‚®°ÏáyfnˆdND£$0JXüÔ”:<¹Hƒò8á CÄqlw{wÀB <”àlª›†vŒg½åiðj7X^h¶˜¦z¬`ßU~”ÝÁ.uÍew¢ˆ­á ü­ìª鑨 Ïû,Ùëʼn@«³j-=­¶[z=Žõ¾±«Æ/@­V‚ÈrÐÁ1 c§!¶3Á Øö6 S`û`Ü]N _ï« í²w]ëÜ›¨K½ŸÊº3ž…Ùƒ‰ Þ$øüã ŽsWáõˆædXAfH¿T¢â]@Tø ¤½ÖÓùî4?U¬k÷Öƒt}ƃϿÑ××çFSÁØÛÄ‚«oõEªÑ÷·ðïP݈hÕØ|i²œz¨W2 —"ʳ⤖$ÊrîxÐ+‰Ä¸ž§Ò¿ÃA)œrölÎë–£m(Ë<’’ݸ›ì )†§qPš4Áð…44YÒIëƒå: ÝMŠ]ê—Qj‹äUT_ZÀ°’8|šÐ3WæÔ6 fu7Ne³D‘¥ sårPªÒ,±`¯ˆpÔs·ì§/ÝxºšAÕm¦X¤b<•“•¦[ȳ3 jdjAc±—ÚèÁÁ¯ä¡<ó®™À–L8Í[hšŸÎ™WVÁ£0`YŸ^>??½¼üB¢5\³Þoy̨fdò÷‡Y%)¸/” n4b$¦à‡> ôÔ¯[«orŠîË“ËÝèÍκu4AƒanÈ$wúãH€W©‘0§ÿs›cþƒdžçµ§äEˆM£kÂö£z« Ì½à†™éàûAÆX Š¥ð8AKÀ¿ûÄ OS^­©§yØëÝÇŸv+·JÓbѱ³™`2‰ò”ß‚ÂVN¿c1óÒ®ÝÒÈ ¾T!ú¦®L!€ä\Ãæ¨ÒE$X¾ oc˘3úz±Düe%X ÂïeWDÑ™.¶V„pèsO[êß:³U“XÞTw-%ôOÄp?;G¢Xbûßkщ\ÜÙÙ¨²bÙGëB}RT¿pfó¬ïÚQ‡¨°¦½½ƒÏ•TÈÛ H}(0’Ãwì!7 ¡ìKÛªi¸¬\\ &¿Åºði÷üâ"EÛÏú@ã/)7Ùšß÷Dqy©€þZõ+~cPðXZüž»QVFñ5?Sº+‚bÅÅ ¤™ãüamI±<¿d¶$ŒG’±·*ß!‰åZìkë{îê\H&ïC $]ù J_CëQ–pCOÖH&¨í×O¹˜Ù¹)f­´®Ò“éýÐWuë½­©åcx/iA!={‹$,&4:â‹"•œ^ËHñK3ν‚'0ÿÏ#ѽ҇»°5´+¯ ßgfdbG“ï‹»²¿¬eÐ²ï› õä® .½—PUͦàm–€>vÁ½;šš6‘»*R°J…´÷µ»8ZÚ]šãq÷ˆFUl‹MQ;ý¸vjÚñ–IL-¶( xu*"T娈d+0 <`¡± áé×ãË„xÊæ¤°k;£©¦¾\£´m¶‹ÂaØés‚wÞ`PTx¨¹Óû¶x>R“xtM@k6 J¦}J’ù¼žÓTCøbOöy·…§›éw]‡ ¸LEF‡ÿ¬¨)€ì7•¾njûï$¤‚äñˆÏ}ž-ô\7/nCKÓÓšN„¹æE­'Asr(’ö$£!ˆ{=×Õ™Hµ=̱/÷=…™Hsº{†Ûu[Žá³*üõšÏ‚_xöH#ž»Añ•˜´©q»¯iÉbÉ-Çp\}hp1ŸÝ` 0‚ {/ š†ÜæÅU0šL:<à§Wà{)Âbò—ùmÆaò†åi÷𕯠endstream endobj 88 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (./figure4_new.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 101 0 R /BBox [0 0 507 612] /Resources << /XObject << /Im0 102 0 R >>/ProcSet [ /PDF /Text /ImageC ] >> /Length 31 >> stream q 507 0 0 612 0 0 cm /Im0 Do Q endstream endobj 102 0 obj << /Type /XObject /Subtype /Image /Name /Im0 /Filter [/RunLengthDecode] /Width 507 /Height 612 /ColorSpace 103 0 R /BitsPerComponent 8 /SMask 104 0 R /Length 105 0 R >> stream ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¡ÿ‚‚‚‚‚‚‚‚‚‚–‚ÿðÿ‚‚‚‚‚‚‚‚‚‚–‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿðÿ‚‚‚Èïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿðÿ‚‚‚Èïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿðÿû‚ÿ‚ÿ‚ÿÔÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿðÿû‚ÿ‚ÿ‚ÿÔÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿðÿû‚ÿ‚ÿ‚ÿÔÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿðÿû‚ÿ‚ÿ‚ÿÔÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿðÿû‚ÿ‚ÿ‚ÿÔÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿðÿû‚ÿ‚ÿ‚ÿÔÿûïÿû‚ÿðÿø‚ÿÿûïÿûïÿøòÿøæÿþ¡ÿþ‚ÿ‚ÿ‚ÿ¹ÿû‚ÿÈÿÿÿ‚ÿ–ÿûïÿû‚ÿðÿø‚ÿ“ÿûþÿûõÿþøÿþøÿþøÿþøÿþøÿþìÿû¡ÿû‚ÿ‚ÿ‚ÿ¼ÿû‚ÿÈÿÿÿ‚ÿ–ÿûïÿû‚ÿðÿø‚ÿ‡ÿþøÿþõÿþøÿþõÿþûÿþõÿþàÿþ¹ÿþ‚ÿ‚ÿ‚ÿ­ÿû‚ÿÈÿÿ‚ÿ“ÿûïÿû‚ÿðÿø‚ÿ‡ÿþøÿþõÿûþÿûõÿþþÿûõÿþãÿû¼ÿû‚ÿ‚ÿ‚ÿ­ÿû‚ÿÈÿþÿ‚ÿ“ÿûïÿû‚ÿðÿø‚ÿ‚ÿúÿþòÿþþÿþòÿþþÿþòÿþïÿûûÿûõÿþþÿþøÿûþÿûþÿûþÿþøÿûøÿûøÿþûÿþøÿûþÿøøÿþûÿþ‚ÿ‚ÿ‚ÿû‚ÿÉÿÿÿ‚ÿ•ÿûïÿû‚ÿðÿø»ÿ.ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿëÿ.ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÅÿûøÿþòÿþþÿþòÿþþÿþòÿþìÿþûÿûøÿþøÿûþÿûõÿþøÿþûÿûøÿûûÿþõÿþøÿûûÿþøÿþûÿþ‚ÿ‚ÿ‚ÿû‚ÿËÿýÿÿÿ‚ÿ˜ÿûïÿû‚ÿðÿø»ÿ.ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿëÿ.ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÂÿûûÿþòÿþþÿþòÿþþÿþòÿþìÿþûÿûøÿïþÿûéÿþûÿûøÿûûÿþõÿûûÿþøÿþøÿû‚ÿ‚ÿ‚ÿûÿû‚ÿÌÿÿþÿÿÿ‚ÿ˜ÿûïÿû‚ÿðÿø‚ÿ„ÿþûÿþòÿþþÿþòÿþþÿþòÿþìÿþûÿûûÿûïÿûïÿþþÿþûÿûøÿûûÿþõÿûûÿþøÿþøÿø‚ÿ‚ÿ‚ÿþÿû‚ÿÌÿ ÿÿÿÿ‚ÿ˜ÿûïÿû‚ÿðÿø‚ÿ„ÿþûÿþòÿþþÿþòÿþþÿþòÿþìÿþûÿûûÿûïÿûõÿþøÿþûÿûøÿûûÿþõÿûûÿþøÿþòÿû‚ÿ‚ÿ‚ÿû‚ÿÌÿÿÿÿÿÿÿ‚ÿœÿûïÿû‚ÿðÿø‚ÿ„ÿþûÿþõÿþøÿþõÿþûÿþõÿþìÿþûÿûøÿûøÿþþÿûõÿþøÿþûÿûøÿûûÿþõÿþøÿþøÿþïÿû‚ÿ‚ÿ…ÿû‚ÿÌÿÿÿÿÿÿÿ‚ÿœÿûïÿû‚ÿðÿø‚ÿ“ÿþéÿþøÿþøÿþøÿþøÿþøÿþéÿþøÿþþÿþûÿõûÿûõÿøþÿûûÿþþÿþþÿûøÿþìÿþøÿþøÿþûÿþ‚ÿ‚ÿ‚ÿû‚ÿÌÿÿýÿÿÿÿïÿÿÿ‚ÿ¶ÿûïÿû‚ÿðÿø‚ÿ“ÿøéÿûïÿûïÿû‚ÿ‚ÿ‚ÿ‚ÿ·ÿû‚ÿÏÿÿÿýÿÿÿîÿ ÿÿÿÿ‚ÿºÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿðÿû‚ÿÏÿÿÿýÿÿÿñÿÿÿÿÿÿ‚ÿºÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿðÿû‚ÿÏÿÿÿýÿÿÿñÿ ÿÿÿÿ‚ÿ¹ÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿðÿû‚ÿÏÿÿÿýÿ ÿÿÿÿõÿÿÿÿÿÿÿ‚ÿ½ÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿðÿû‚ÿÏÿÿÿýÿ ÿÿÿÿõÿÿÿÿþÿÿÿ‚ÿ½ÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿðÿû‚ÿÏÿÿÿýÿ ÿÿÿÿõÿÿÿÿþÿÿÿ‚ÿ½ÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿðÿû‚ÿÏÿÿÿýÿ ÿÿÿÿøÿÿÿýÿÿÿÿ‚ÿ½ÿûïÿû‚ÿðÿø‚ÿÿõõÿûþÿþòÿþìÿþãÿû¡ÿû‚ÿ‡ÿø×ÿû‚ÿðÿû‚ÿÏÿÿÿúÿÿÿÿøÿÿÿýÿÿÿÿ‚ÿ½ÿûïÿû‚ÿðÿø‚ÿ“ÿþøÿþõÿþøÿþøÿþøÿþøÿþøÿþéÿþ¡ÿþ‚ÿ‚ÿÿûÔÿþ‚ÿðÿû‚ÿÏÿÿÿúÿÿÿ÷ÿÿÿýÿÿÿ‚ÿ¼ÿûïÿû‚ÿðÿø‚ÿ‡ÿþøÿþõÿûþÿûõÿþþÿûõÿþàÿþ¹ÿþ‚ÿØÿþ¡ÿûãÿþ‚ÿáÿû‚ÿÏÿÿ÷ÿÿÿ÷ÿÿúÿÿÿ‚ÿ¼ÿûïÿû‚ÿðÿø‚ÿ‡ÿþøÿþòÿþþÿþòÿþþÿþòÿþãÿû¼ÿûžÿþÂÿû¡ÿûãÿþ‚ÿáÿû‚ÿÏÿÿ÷ÿÿÿ÷ÿÿúÿ ÿÿÿÿ‚ÿÀÿûïÿû‚ÿðÿø‚ÿŠÿþõÿþòÿþþÿþòÿþþÿþòÿþòÿøûÿûìÿþþÿïþÿþûÿûûÿûûÿøøÿþûÿûûÿïøÿþûÿþòÿþïÿþûÿûûÿûûÿþøÿûûÿûþÿûþÿþøÿþþÿéûÿþøÿþøÿûûÿþøÿþøÿþøÿûøÿþøÿþûÿì¤ÿû‚ÿÒÿÿÿôÿÿ÷ÿ ÿÿÿÿý ÿÿÿÿ‚ÿÀÿûïÿû‚ÿðÿø‚ÿÿøøÿþòÿþþÿþòÿþþÿþòÿþìÿþûÿûøÿþøÿûþÿûõÿûûÿþûÿûøÿûûÿþõÿþøÿþøÿþøÿþûÿþòÿþòÿþõÿþøÿþþÿþõÿûøÿþõÿûûÿþûÿûøÿûþÿþõÿûûÿûûÿûûÿþøÿþõÿþøÿþõÿþøÿþøÿþ¤ÿû‚ÿÒÿÿÿôÿÿÿÿþÿ ÿÿÿÿûÿÿÿÿ‚ÿÀÿûïÿû‚ÿðÿø¼ÿÿÿìÿ/ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿìÿÿÿìÿÿÿÎÿûûÿþòÿþþÿþòÿþþÿþòÿþìÿþûÿûûÿûïÿûìÿûûÿûøÿûûÿþõÿûûÿþøÿþøÿûõÿéþÿþæÿþòÿûøÿþìÿûûÿûõÿþþÿþòÿþûÿûòÿûøÿþõÿþûÿûõÿþøÿþøÿþ¤ÿû‚ÿÒÿÿÿôÿÿúÿ ÿÿÿÿûÿÿÿÿ‚ÿÀÿûïÿû‚ÿðÿø¼ÿÿÿìÿ/ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿìÿÿÿìÿÿÿËÿþûÿþòÿþþÿþòÿþþÿþòÿþìÿþûÿûûÿûïÿûòÿþûÿþûÿûøÿûûÿþõÿûûÿþøÿþõÿûøÿéþÿþæÿûõÿûøÿþòÿþûÿþûÿûõÿþþÿþòÿþûÿûøÿûþÿþøÿþõÿþûÿûõÿþøÿþøÿþ¤ÿû‚ÿÒÿÿÿôÿÿÿýÿ ÿÿÿÿûÿÿ‚ÿ¼ÿûïÿû‚ÿðÿø¼ÿÿÿìÿ/ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿìÿÿÿìÿÿÿËÿþûÿþõÿûþÿûõÿþþÿûõÿþìÿþûÿûûÿûïÿûõÿþøÿþûÿûøÿûûÿþõÿûûÿþøÿþïÿûõÿþòÿþéÿþþÿûøÿûøÿþõÿþøÿþûÿûõÿþþÿûõÿþûÿûûÿþøÿþøÿþõÿþûÿûõÿþøÿþøÿþ¤ÿû‚ÿÒÿÿÿôÿÿÿÿÿÿÿÿÿûÿÿÿÿ‚ÿÀÿûïÿû‚ÿðÿø‚ÿ„ÿþûÿþõÿþøÿþõÿþûÿþõÿþìÿþûÿûøÿûøÿþþÿûõÿþøÿþûÿûøÿûûÿûøÿþøÿþøÿþïÿûõÿþòÿûøÿþïÿþøÿûøÿþõÿþøÿþûÿûõÿþûÿþøÿûûÿûûÿþøÿþøÿþõÿþøÿþõÿþøÿþøÿþ¤ÿû‚ÿÒÿÿÿôÿÿÿÿÿÿÿÿøÿÿÿÿ‚ÿÀÿûïÿû‚ÿðÿø‚ÿ“ÿûûÿþõÿþøÿþøÿþøÿþøÿþøÿþìÿûøÿûøÿøøÿûõÿøþÿûûÿûûÿûøÿþûÿþõÿûûÿûûÿþûÿþòÿþïÿõøÿþøÿûøÿûûÿûøÿøþÿûþÿøþÿûõÿþïÿûûÿøþÿûûÿøþÿûõÿþûÿþøÿûûÿû¤ÿû‚ÿÒÿÿÿñÿÿÿÿÿÿÿøÿÿÿ‚ÿ¿ÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿëÿû‚ÿÿû‚ÿÒÿÿÿñÿÿÿÿÿÿÿøÿÿÿ‚ÿ¿ÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿëÿû‚ÿÿû‚ÿÒÿÿÿñÿÿÿÿÿÿÿøÿÿÿ‚ÿ¿ÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿëÿû‚ÿÿû‚ÿÒÿÿÿðÿý ÿÿÿÿÿøÿ ÿÿÿÿ‚ÿÃÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿîÿõ‚ÿÿû‚ÿÒÿÿÿÿîÿ ÿÿÿòÿÿÿÿ‚ÿÃÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿðÿû‚ÿÒÿÿÿÿîÿ ÿÿÿòÿÿÿÿ‚ÿÃÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿðÿû‚ÿÕÿÿÿêÿ ÿÿÿòÿÿÿ‚ÿÂÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿðÿû‚ÿÕÿÿÿÐÿÿÿ‚ÿÂÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿðÿû‚ÿÕÿÿÿÐÿÿÿ‚ÿîÿÿÿÝÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿðÿû‚ÿÕÿÿÿÐÿ ÿÿÿÿ‚ÿòÿ ÿÿÿàÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿðÿû‚ÿÕÿÿÿÐÿ ÿÿÿÿ‚ÿõÿ ÿÿÿÿàÿûïÿû‚ÿðÿø‚ÿ‚ÿôÿûïÿøòÿøæÿþ¡ÿþ‚ÿ‚ÿýÿþÔÿþ‚ÿðÿû‚ÿÕÿÿÿÐÿ ÿÿÿÿ‚ÿõÿ ÿÿÿÿàÿûïÿû‚ÿðÿø‚ÿÿõøÿþøÿþøÿþøÿþøÿþøÿþìÿû¡ÿû‚ÿ„ÿû×ÿû‚ÿðÿû‚ÿÕÿÿÍÿ ÿÿÿÿ‚ÿõÿ ÿÿÿÿæÿÿÿúïÿû‚ÿðÿø‚ÿÿþïÿþõÿþøÿþõÿþûÿþõÿþàÿþ¹ÿþ‚ÿØÿþ¡ÿû‚ÿÀÿû‚ÿÕÿÿÊÿÿÿÿ‚ÿõÿ ÿÿÿÿæÿÿÿúïÿû‚ÿðÿø‚ÿ“ÿûïÿþòÿþþÿþòÿþþÿþòÿþãÿû¼ÿûžÿþÂÿû¡ÿûãÿþ‚ÿáÿû‚ÿÕÿÿÊÿÿÿÿ‚ÿõÿÿýÿÿÿéÿÿÿúïÿû‚ÿðÿø‚ÿ“ÿõõÿþòÿþþÿþòÿþþÿþòÿþïÿûûÿûõÿþþÿþøÿûþÿûþÿûþÿþøÿûøÿûøÿþûÿþøÿûþÿøøÿþûÿþòÿþæÿþøÿûûÿþøÿûøÿþþÿûûÿþþÿûûÿûþÿøõÿþþÿþõÿûøÿþþÿûøÿþøÿûõÿþûÿþøÿûþÿû¡ÿû‚ÿÕÿÿÊÿÿÿ‚ÿ÷ÿÿÿýÿÿÿåÿùïÿû‚ÿðÿø‚ÿŠÿûøÿþòÿþþÿþòÿþþÿþòÿþìÿþûÿûøÿþøÿûþÿûõÿþøÿþûÿûøÿûûÿþõÿþøÿûûÿþøÿþûÿþòÿþæÿûøÿþïÿûøÿûøÿþøÿþûÿûøÿûûÿþøÿûûÿûûÿþøÿþøÿþõÿþøÿþøÿûøÿþøÿþ¤ÿû‚ÿÕÿÿÊÿÿÿ‚ÿ÷ÿÿÿýÿÿãÿÿûïÿû‚ÿðÿø¼ÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÍÿûûÿþòÿþþÿþòÿþþÿþòÿþìÿþûÿûøÿïþÿûéÿþûÿûøÿûûÿþõÿûûÿþøÿþøÿûìÿþòÿïøÿøõÿûøÿþéÿþûÿûõÿþþÿþòÿþûÿûïÿþøÿþõÿþûÿûõÿþøÿþøÿþ¤ÿû‚ÿØÿÿÿÊÿÿÿ‚ÿôÿÿÝÿÿÿûïÿû‚ÿðÿø¼ÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÊÿþûÿþòÿþþÿþòÿþþÿþòÿþìÿþûÿûûÿûïÿûòÿþûÿþûÿûøÿûûÿþõÿûûÿþøÿþõÿûøÿéþÿþæÿûõÿûøÿþòÿþûÿþûÿûõÿþþÿþòÿþûÿûøÿûþÿþøÿþõÿþûÿûõÿþøÿþøÿþ¤ÿû‚ÿØÿÿÿÊÿ ÿÿÿÿ‚ÿÒÿÿÿÿûïÿû‚ÿðÿø¼ÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÊÿþûÿþõÿûþÿûõÿþþÿûõÿþìÿþûÿûûÿûïÿûõÿþøÿþûÿûøÿûûÿþõÿûûÿþøÿþïÿûõÿþòÿþéÿþþÿûøÿûøÿþõÿþøÿþûÿûõÿþþÿûõÿþûÿûûÿþøÿþøÿþõÿþûÿûõÿþøÿþøÿþ¤ÿû‚ÿØÿÿÿÊÿÿÿ‚ÿÑÿ ÿÿÿÿûïÿû‚ÿðÿø‚ÿ‚ÿúÿþõÿþøÿþõÿþûÿþõÿþìÿþûÿûøÿûøÿþþÿûõÿþøÿþûÿûøÿûûÿþõÿþøÿþøÿþïÿûõÿþòÿûìÿþþÿûøÿûøÿþõÿþøÿþûÿûõÿþþÿûõÿþûÿûûÿþøÿþøÿþõÿþøÿþõÿþøÿþøÿþ¤ÿû‚ÿØÿÿÿÊÿÿÿ‚ÿÑÿ ÿÿÿÿûïÿû‚ÿðÿø‚ÿ“ÿþøÿþõÿþøÿþøÿþøÿþøÿþøÿþéÿþøÿþþÿþûÿõûÿûõÿøþÿûûÿþþÿþþÿûøÿþìÿþøÿþøÿþûÿþòÿþïÿõøÿþøÿûøÿþøÿþõÿïþÿûøÿþøÿûûÿþøÿûûÿïûÿûøÿþøÿûûÿþõÿþøÿþ¤ÿû‚ÿØÿÿÿÇÿÿÿÿ‚ÿöÿÿÿÿÿÿôÿ ÿÿÿÿÿùïÿû‚ÿðÿø‚ÿ“ÿøéÿûïÿûïÿû‚ÿ‚ÿ²ÿû‚ÿÿû‚ÿØÿÿÿÿÈÿÿÿ‚ÿþÿÿÿþÿÿÿÿÿÿÿÿýÿÿÿÿÿÿÿùïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿëÿû‚ÿÿû‚ÿØÿÿÄÿÿÿ‚ÿþÿÿÿþÿÿýÿ!ÿÿÿÿÿÿÿÿÿÿÿÿùïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿëÿû‚ÿÿû‚ÿØÿÿÄÿÿÿ‚ÿýÿýÿÿÿýÿÿÿÿýÿÿÿÿÿÿýÿÿùïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿëÿû‚ÿÿû‚ÿØÿÿÁÿÿ‚ÿýÿýÿÿýÿÿÿÿÿÿûÿÿÿÿÿÿÿùïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿðÿû‚ÿÛÿÿÿÁÿÿÿÿƒÿÿÿ÷ÿ ÿÿÿÿþÿÿÿÿÿÿÿÿùïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿðÿû‚ÿÛÿÿÿÁÿÿÿ‚ÿÿÿ÷ÿÿÿÿÿÿÿÿÿýÿÿÿùïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿðÿû‚ÿÛÿÿÿÁÿÿÿ…ÿÿÿñÿÿÿÿÿÿÿòÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿðÿû‚ÿÛÿÿÿÁÿÿÿçÿÿ§ÿ ÿÿÿñÿÿÿÿÿÿÿòÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿðÿû‚ÿÛÿÿÿÿ¿ÿÿÿíÿ ÿÿÿ­ÿÿþ ÿÿÿÿîÿÿÿìÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿðÿû‚ÿÞÿÿÿ»ÿÿÿúÿÿÿÿÿÿÿÿÿ­ÿÿþ ÿÿÿÿëÿÿìÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ™ÿÿÿ‚ÿáÿû‚ÿÞÿÿÿ»ÿÿþ$ÿÿÿÿÿÿÿÿÿÿÿÿÿ°ÿ ÿÿÿÿèÿÿÿïÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ™ÿÿÿ‚ÿáÿû‚ÿÞÿÿÿºÿý$ÿÿÿÿÿÿÿÿÿÿÿÿÿ°ÿ ÿÿÿÿèÿÿÿïÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ™ÿÿÿ‚ÿáÿû‚ÿÿÿÿåÿÿÿ¸ÿÿþÿÿÿúÿÿÿüÿÿÍÿéÿÿþ ÿÿÿÿåÿ ÿÿÿÿøÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ™ÿÿÿ‚ÿáÿûƒÿ ÿÿÿèÿÿÿ·ÿþÿÿõÿÿÿüÿÿÿÓÿÿÿìÿÿÿÿÿÿåÿ ÿÿÿÿøÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ™ÿÿÿ‚ÿáÿû†ÿÿÿÿÿÿîÿÿÿ´ÿÿÿòÿÿÿÿÿÿÿÖÿ ÿÿÿÿïÿÿÿÿÿÿâÿÿÿõÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ™ÿÿÿ…ÿÿãÿû†ÿÿÿÿÿÿîÿÿÿ±ÿ ÿÿÿøÿÿÿüÿÿÐÿ ÿÿÿõÿÿÿÿÿÿËÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ™ÿÿÿ…ÿÿÿæÿû†ÿÿÿÿÿÿîÿÿÿ±ÿ ÿÿÿÿûÿÿÿüÿÿÍÿÿÿõÿÿÿÿÿÿËÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ™ÿÿÿ…ÿÿÿæÿû‰ÿÿÿúÿÿÿñÿÿÿ®ÿ ÿÿÿÿûÿÿÿÿÿÿÿÐÿÿÿøÿÿÿÿÿÿÿËÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿœÿ ÿÿÿ…ÿÿÿæÿû‰ÿÿÿúÿÿÿôÿÿÿ—ÿÿÿÿÿÿÿÍÿÿÿþÿ ÿÿÿÁÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ™ÿÿ‚ÿÿÿæÿû‰ÿÿÿ÷ÿÿÿ÷ÿÿÿ”ÿÿÿÿÿÿàÿ ÿÿÿÿúÿÿÿþÿÿÿ¾ÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ”ÿÿÿæÿû‰ÿÿÿ÷ÿÿÿ÷ÿÿÿÿ•ÿÿÿÿÿÿÿãÿÿÿÿ÷ÿÿÿýÿÿÿ¾ÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ”ÿÿÿæÿû‰ÿÿÿÿõÿÿÿÿþÿÿÿŽÿ ÿÿÿÿâÿý ÿÿÿÿÿÿÿÿÿÿÿ»ÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ”ÿÿÿæÿûŒÿÿÿñÿÿÿÿÿÿÿ‹ÿÿÿÿÿÿÿîÿ&ÿÿÿÿÿÿÿÿÿÿÿÿÿ¼ÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ·ÿ‚ÿÝÿÿæÿûŒÿÿÿîÿ ÿÿÿÿ…ÿÿÿÿÿÿÿÿÿýÿ ÿÿÿÿôÿÿÿÿÿÿÿÿ¿ÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ·ÿ‚ÿÝÿÿÿéÿûŒÿÿèÿÿÿ‚ÿþÿÿÿÿþÿÿÿÿÿÿÿÿÿçÿ ÿÿÿ¿ÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿºÿÿÿ‚ÿàÿÿÿéÿûŒÿÿ‚ÿÝÿ ÿÿÿÿþÿÿÿÿÿÿÿÿÿåÿÿ¼ÿûïÿû¿ÿþ¶ÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿºÿÿÿëÿ ÿÿÿÿ…ÿÿÿéÿûÿÿÿ‚ÿÚÿ ÿÿÿÿÿÿÿÿÿÿÿ˜ÿûïÿû¿ÿû¹ÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿºÿÿÿëÿ ÿÿÿÿ…ÿÿæÿûÿÿÿ‚ÿ×ÿÿÿÿÿÿÿýÿÿÿ˜ÿûïÿû¿ÿòÂÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿºÿÿÿëÿ ÿÿÿÿëÿ‚ÿüÿûÿÿ‚ÿÓÿ ÿÿÿúÿÿÿ•ÿûïÿû¿ÿþûÿõÈÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿºÿÿÿëÿ ÿÿÿÿëÿÿ¦ÿÿÿãÿû’ÿÿÿ‚ÿÐÿÿÿÿÿÿÿÿ•ÿûïÿû­ÿøÎÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿºÿÿÿëÿ ÿÿÿÿîÿÿÿ¦ÿÿÿãÿû’ÿÿÿ‚ÿÍÿÿÿÿÿÿ’ÿûïÿû¤ÿø×ÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿºÿ ÿÿÿîÿ ÿÿÿÿîÿÿÿ¦ÿÿÿãÿû•ÿÿÿ‚ÿÄÿÿŒÿûïÿû¤ÿïàÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿºÿ ÿÿÿîÿ ÿÿÿÿîÿÿÿ¦ÿÿÿãÿû•ÿÿÿ‚ÿ‚ÿÉÿûïÿû­ÿïøÿûæÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿºÿÿèÿ ÿÿÿÿëÿÿ¦ÿÿÿãÿû³ÿÿÿîÿ ÿÿÿ‚ÿ‚ÿÉÿûïÿû¿ÿþõÿïòÿûéÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ½ÿÿÿèÿ ÿÿÿÿëÿÿ¦ÿ ÿÿÿÿéÿû¶ÿÿÿÿÿÿÿõÿÿÿ‚ÿ‚ÿÆÿûïÿû¿ÿéãÿûïÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿœÿ ÿÿÿÿëÿÿ¦ÿ ÿÿÿÿéÿû¹ÿÿÿÿÿÿÿÿúÿ ÿÿÿ‚ÿ‚ÿÆÿûïÿû¿ÿïÝÿûïÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿœÿ ÿÿÿÿëÿÿ¦ÿ ÿÿÿÿéÿû¼ÿ ÿÿÿúÿÿÿÿÿÿÿ‚ÿ‚ÿÀÿûïÿû¿ÿø×ÿøïÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿœÿ ÿÿÿÿëÿÿ¦ÿ ÿÿÿÿéÿû¼ÿÿÿôÿ ÿÿÿÿ‚ÿ‚ÿ½ÿûïÿû¿ÿûÔÿøïÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿœÿ ÿÿÿÿëÿÿ¦ÿ ÿÿÿÿéÿû¿ÿ ÿÿÿñÿÿÿÿû›ÿû›ÿû›ÿûïÿû¿ÿþÎÿþìÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿœÿ ÿÿÿÿëÿÿ¦ÿ ÿÿÿÿéÿû¿ÿÿÿåÿû›ÿû›ÿû›ÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ·ÿÿÿîÿ ÿÿÿÿñÿ ÿÿÿ¦ÿ ÿÿÿÿéÿûÂÿÿÿâÿû›ÿû›ÿû›ÿûïÿû¿ÿþàÿþÚÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ·ÿÿÿîÿÿýÿÿñÿ ÿÿÿÿ©ÿ ÿÿÿÿéÿûÅÿÿÿßÿû›ÿû›ÿû›ÿûïÿû¿ÿþÝÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ½ÿ ÿÿÿÿÐÿ ÿÿÿÿåÿÿÊÿ ÿÿÿÿéÿûËÿ ÿÿÿÿßÿû›ÿû›ÿû›ÿûïÿû¿ÿþàÿûÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ½ÿ ÿÿÿÿÐÿ ÿÿÿÿåÿÿÿÍÿ ÿÿÿÿéÿûÎÿ ÿÿÿÿÜÿû›ÿû›ÿû›ÿûïÿûÈÿÎÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ½ÿ ÿÿÿÿÐÿÿÿâÿ ÿÿÿÍÿ ÿÿÿÿéÿû×ÿÿÿÿÿÿÿÙÿû›ÿû›ÿû›ÿûïÿûÅÿÔÚÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ½ÿ ÿÿÿÿÐÿÿÿâÿ ÿÿÿÇÿÿÿéÿûæÿÿÿÿÿÿÿÿÿÿÓÿû›ÿû›ÿû›ÿûïÿû¿ÿþ¶ÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ½ÿ ÿÿÿÿÐÿÿÿâÿ ÿÿÿÇÿÿÿéÿù,ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÊÿû›ÿû›ÿû›ÿûïÿû¿ÿþ¶ÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ½ÿ ÿÿÿÿÐÿÿÿâÿ ÿÿÿÇÿÿÿéÿ‚‚‚Èïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ½ÿ ÿÿÿÿÐÿÿÿâÿ ÿÿÿÄÿÿéÿ‚‚‚Èïÿû˜ÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ½ÿ ÿÿÿÿñÿÿÿýÿÿñÿÿÿâÿ ÿÿÿÄÿÿ‚ÿ‚ÿ‚ÿžÿû˜ÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ½ÿ ÿÿÿÿñÿÿÿýÿÿÿôÿ ÿÿÿÿâÿÿ‚ÿ‚ÿ‚ÿ‚ÿÛÿûÑÿûõÿ×Ýÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿüÿÿÇÿ ÿÿÿÿñÿÿÿýÿÿÿôÿ ÿÿÿÿâÿÿ‚ÿ‚ÿ‚ÿ‚ÿÛÿûÑÿûõÿ×Ýÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿüÿÿÇÿÿýÿÿñÿÿÿýÿÿÿôÿ ÿÿÿÿâÿÿÍÿÿ‚ÿ‚ÿ‚ÿ•ÿûÑÿûòÿÚÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ ÿÿÿÿÿÊÿÿýÿÿñÿÿÿýÿÿÿôÿ ÿÿÿÿÁÿÿîÿÿ‚ÿ‚ÿ‚ÿ•ÿû¼ÿþàÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ ÿÿÿÿÿÊÿÿýÿÿñÿÿÿýÿÿÿôÿÿýÿÿÄÿÿÿîÿÿàÿû•ÿû˜ÿû¡ÿû’ÿûûÿû˜ÿþÝÿø¶ÿûÎÿþ‚ÿ‚ÿ‚ÿˆÿ ÿÿÿÊÿÿýÿÿñÿÿÿýÿÿÿôÿÿýÿÿÁÿÿñÿÿÿæÿûþÿø›ÿûžÿþžÿþøÿþ°ÿøòÿþøÿø˜ÿþÝÿø¹ÿþÅÿþ‚ÿ‚ÿ‚ÿˆÿÿÿÊÿÿèÿÿÿýÿÿÿëÿÿÁÿÿñÿÿÿæÿþøÿûžÿø¡ÿþžÿûõÿþ­ÿþõÿûøÿø‚ÿðÿø¼ÿþ¿ÿû‚ÿ‚ÿ‚ÿŽÿÿÿÊÿÿèÿÿÿýÿÿÿëÿÿèÿÿÿâÿÿÿôÿÿÿýÿÿÿãÿþ›ÿû¤ÿþ›ÿûõÿþ­ÿþõÿûøÿø§ÿõ×ÿø¿ÿþ¹ÿþ‚ÿ‚ÿ‚ÿŽÿÿÿèÿÿÊÿÿÿýÿÿÿëÿÿèÿÿßÿÿÿôÿÿÿýÿÿÿãÿþ›ÿû§ÿû˜ÿûûÿþªÿþõÿþòÿû¿ÿõøÿïÚÿøÂÿû¶ÿû‚ÿ‚ÿ‚ÿ”ÿÿÿëÿÿÿÊÿÿÿýÿÿÿûÿÿôÿÿèÿÿßÿÿÿôÿÿÿýÿÿÿæÿû¤ÿþûÿû§ÿûûÿû¡ÿû¤ÿþõÿþòÿû¿ÿûòÿøøÿþÝÿøÅÿû³ÿû‚ÿ‚ÿ‚ÿ²ÿåÿÿÿëÿ ÿÿÿÍÿÿÿýÿÿÿý ÿÿÿÿ÷ÿÿèÿ ÿÿÿåÿÿÿôÿÿÿýÿÿÿæÿþ¤ÿþøÿû§ÿþõÿû¤ÿõªÿþõÿþòÿû¿ÿþòÿøõÿþÝÿøÅÿû°ÿû‚ÿ‚ÿ‚ÿµÿåÿÿÿëÿ ÿÿÿÍÿÿÿýÿÿÿý ÿÿÿÿ÷ÿÿÿëÿ ÿÿÿÿèÿÿÿôÿÿÿýÿÿÿéÿþ•ÿû§ÿþòÿþ§ÿþûÿûªÿþõÿþòÿû¿ÿþõÿõõÿþÝÿøÈÿû­ÿû‚ÿ‚ÿ‚ÿ¸ÿÿèÿ ÿÿÿëÿ ÿÿÿÜÿôÿÿÿýÿÿý ÿÿÿÿöÿÿÿëÿ ÿÿÿÿëÿ ÿÿÿøÿ ÿÿÿÿýÿÿÿ‰ÿéªÿþòÿþªÿûøÿû­ÿþõÿþòÿû¿ÿþõÿøòÿþÝÿøÈÿûàÿûûÿûÝÿû‚ÿ‚ÿ‚ÿ»ÿÿÿëÿ ÿÿÿëÿ ÿÿÿâÿÿÿôÿÿÿýÿÿýÿÿÿÿÿÿÿýÿÿÿëÿ ÿÿÿÿëÿ ÿÿÿûÿÿÿÿÿÿýÿÿÿ‚ÿùÿû§ÿûõÿþªÿûõÿþ­ÿþõÿûøÿø¿ÿûûÿøïÿþÝÿøËÿøæÿûòÿûàÿû‚ÿ‚ÿ‚ÿ¾ÿ ÿÿÿëÿ ÿÿÿëÿ ÿÿÿëÿÿýÿÿÿôÿÿÿýÿýÿÿÿÿÿÿÿÿýÿÿÿîÿÿÿÿÿÿîÿ ÿÿÿÿûÿÿÿÿÿÿýÿÿÿòÿìžÿû§ÿûøÿþ¤ÿþõÿþ­ÿþòÿþøÿø¼ÿïòÿþÚÿøËÿøæÿûòÿøãÿû‚ÿ‚ÿ‚ÿ¾ÿ ÿÿÿëÿ ÿÿÿëÿ ÿÿÿëÿÿýÿÿÿôÿÿÿûÿ ÿÿÿÿþ ÿÿÿÿýÿÿÿîÿÿÿÿÿÿîÿ ÿÿÿÿþÿÿÿÿÿÿÿÿÿÿÿòÿï›ÿû¤ÿþøÿþ¤ÿþøÿþ­ÿûæÿø¹ÿøõÿòÝÿøËÿûæÿøòÿøãÿø‚ÿ‚ÿ‚ÿÁÿ ÿÿÿëÿÿåÿ ÿÿÿëÿÿýÿÿÿéÿ ÿÿÿÿÿþ ÿÿÿÿâÿÿÿÿÿÿîÿ ÿÿÿÿþÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ¡ÿû‚ÿðÿøËÿûãÿûòÿøãÿø‚ÿ‚ÿ‚ÿÁÿ ÿÿÿëÿÿßÿÿîÿÿÿýÿÿÿéÿÿÿÿÿÿþÿ ÿÿÿÿåÿÿÿÿÿÿîÿ ÿÿÿÿþÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ¡ÿû‚ÿðÿøËÿûÎÿøãÿø‚ÿ‚ÿ‚ÿÁÿ ÿÿÿëÿÿÇÿÿÿýÿÿÿéÿÿÿÿÿÿþÿ ÿÿÿÿåÿÿÿÿÿÿîÿ ÿÿÿÿþÿÿÿÿÿÿÿýÿÿÿ‚ÿ‚ÿ‚ÿ¡ÿû˜ÿþÝÿøËÿû×ÿïãÿø‚ÿ‚ÿ‚ÿ»ÿÿëÿÿÇÿÿÿýÿÿÿéÿÿÿÿÿÿþÿ ÿÿÿÿåÿÿÿÿÿÿîÿ ÿÿÿÿþÿ ÿÿÿÿùÿÿÿ‚ÿ‚ÿ‚ÿ¡ÿû˜ÿþÝÿøËÿûÚÿûûÿøãÿø‚ÿ‚ÿ‚ÿ»ÿÿîÿÿÿÇÿÿÿýÿÿÿìÿÿÿÿÿÿúÿýÿáÿÿÿÿÿÿîÿÿÿøÿÿÿÿÿÿüÿÿÿ‚ÿ‚ÿ‚ÿ¡ÿû¼ÿÚÝÿøËÿûàÿûõÿøãÿø‚ÿ‚ÿ‚ÿ»ÿÿîÿÿÿÇÿÿÿýÿÿÿìÿ ÿÿÿÿ÷ÿýÿÿäÿÿÿÿÿÿîÿÿÿøÿÿÿÿþÿÿüÿÿÿ‚ÿ‚ÿ‚ÿ¡ÿû¿ÿ×ÝÿøËÿûãÿûòÿøãÿø‚ÿ‚ÿ‚ÿ»ÿÿîÿÿÿÿÿÿÐÿÿÿýÿÿÿôÿÿþÿþ ÿÿÿÿÿúÿýÿÿäÿÿÿÿÿÿîÿÿÿûÿ ÿÿÿÿþÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ¡ÿû¿ÿøãÿþÝÿøËÿûæÿøòÿøãÿø‚ÿ‚ÿ‚ÿ£ÿÿÿÿÿÿîÿÿèÿÿÿýÿÿÿôÿýÿÿÿÿÿÿÿúÿýÿÿÿÿÿÿâÿÿîÿÿÿûÿÿÿúÿÿÿ‚ÿ‚ÿ‚ÿ—ÿû¿ÿûàÿþÝÿøËÿøéÿøòÿøãÿø‚ÿ‚ÿ‚ÿ£ÿÿÿÿÿÿîÿÿèÿÿÿýÿÿÿõÿÿÿÿÿÿÿÿÿúÿýÿÿÿÿÿÿâÿÿîÿÿÿûÿÿÿúÿÿÿ‚ÿ‚ÿ‚ÿ—ÿû¿ÿû¹ÿøËÿøéÿøòÿøãÿû‚ÿ‚ÿ‚ÿ ÿÿÿÿÿÿñÿÿÿÿÿÿñÿÿÿýÿÿÿøÿÿþÿÿÿÿÿÿÿÿúÿýÿÿÿÿÿÿâÿÿîÿÿøÿÿÿüÿÿýÿÿÿ‚ÿ‚ÿ‚ÿ›ÿû¼ÿþàÿþÝÿøÈÿûéÿõøÿòæÿû‚ÿ‚ÿ‚ÿ¾ÿÿÿëÿÿÿÿÿÿñÿÿÿÿÿÿñÿÿÿýÿÿÿûÿÿÿþÿöÿÿÿúÿýÿÿÿÿÿÿÊÿÿøÿÿÿüÿÿýÿÿ‚ÿ‚ÿ‚ÿšÿû¹ÿþãÿþÝÿøÈÿûéÿìþÿïïÿû‚ÿ‚ÿ‚ÿ÷ÿÇÿÿèÿÿÿÿÿÿñÿÿÿÿÿÿñÿÿþ ÿÿÿÿÿþÿ ÿÿÿÿöÿÿÿúÿýÿÿÿÿÿÿÊÿÿýÿÿýÿùÿÿýÿÿ‚ÿ‚ÿ‚ÿšÿû¿ÿ×ÝÿøÅÿûéÿõõÿõìÿû‚ÿ‚ÿ‚ÿúÿÿÇÿÿèÿÿÿÿÿÿñÿÿÿÿÿÿñÿþ ÿÿÿÿþÿÿþÿÿÿÿÿÿ÷ÿÿÿúÿÿý ÿÿÿÿÿÁÿÿýÿùÿÿýÿÿ‚ÿ‚ÿ‚ÿšÿû¿ÿ×ÝÿøÅÿû³ÿø‚ÿ‚ÿ‚ÿúÿÿÿÊÿÿßÿÿÿñÿÿÿÿÿÿñÿþÿÿÿþÿÿÿÿÿÿÿÿÿ÷ÿÿÿõÿÿÿÿÿÿÁÿÿýÿùÿÿýÿÿ‚ÿ‚ÿ‚ÿšÿû¼ÿÚÝÿøÂÿû¶ÿû‚ÿ‚ÿ‚ÿ÷ÿÿÿÊÿ ÿÿÿÿèÿÿÿñÿÿÿÿÿÿñÿþÿþÿÿÿÿÿÿÿüÿÿ÷ÿÿÿõÿÿÿÿÿÿîÿÿÿÜÿÿýÿÿÿýÿÿþÿ ÿÿÿÿ‚ÿ‚ÿ‚ÿ¡ÿû¼ÿþàÿþÝÿø¿ÿþ¹ÿû‚ÿ‚ÿ‚ÿôÿÿÿÊÿ ÿÿÿÿèÿÿÿñÿÿÿÿÿÿòÿÿþÿÿÿÿÿÿÿÿüÿÿ÷ÿÿÿõÿÿÿÿÿÿîÿÿÿÜÿÿýÿÿÿýÿÿþÿ ÿÿÿ‚ÿ‚ÿ‚ÿ ÿû˜ÿþÝÿø¼ÿþ¿ÿû‚ÿ‚ÿ‚ÿñÿÿÿÊÿ ÿÿÿÿèÿÿÿñÿÿÿÿÿÿòÿÿþ ÿÿÿÿÿþÿÿùÿÿ÷ÿÿÿõÿÿÿÿÿÿîÿÿÿúÿåÿýÿÿùÿÿûÿÿÿ‚ÿ‚ÿ‚ÿ ÿû‚ÿðÿø¹ÿþÂÿþ‚ÿ‚ÿ‚ÿëÿÿÍÿÿÿÿÿÿèÿÿÿñÿÿÿÿÿÿòÿÿþÿÿÿÿÿÿÿ÷ÿÿ÷ÿÿÿõÿÿÿÿÿÿîÿÿÿýÿÿåÿýÿÿùÿÿøÿÿ‚ÿ‚ÿ‚ÿ ÿû³ÿþõÿûÔÿø¶ÿþËÿû‚ÿ‚ÿ‚ÿèÿÿÍÿÿÿÿÿÿèÿÿÿñÿÿÿÿÿÿõÿÿÿþÿýÿÿÿÿÿÿúÿÿ÷ÿÿÿõÿÿÿÿÿÿîÿÿÿýÿÿåÿýÿÿùÿÿûÿÿþÿ‚ÿ‚ÿ‚ÿ ÿû¹ÿøïÿþ×ÿø‚ÿ‚ÿ‚ÿ‚ÿÝÿÿÍÿÿÿÿÿÿñÿÿýÿÿÿñÿÿÿÿÿÿòÿÿÿùÿÿþÿÿýÿÿÿ÷ÿÿÿúÿûÿ ÿÿÿÿîÿÿÿýÿÿîÿÿýÿýÿÿùÿÿûÿÿþÿÿ‚ÿ‚ÿ‚ÿ£ÿû¼ÿõìÿþÚÿø‚ÿ‚ÿ‚ÿ‚ÿÝÿÿëÿÿèÿÿÿÿÿÿñÿÿýÿÿÿñÿÿÿÿÿÿòÿÿÿùÿÿ÷ÿÿÿ÷ÿÿÿýÿÿÿþÿ ÿÿÿÿîÿÿÿýÿÿîÿÿýÿýÿöÿÿûÿÿþÿÿ‚ÿ‚ÿ‚ÿ£ÿû¿ÿøæÿûÝÿø‚ÿ‚ÿ‚ÿ‚ÿãÿ ÿÿÿëÿÿÿëÿÿÿýÿÿñÿÿýÿÿÿñÿÿÿýÿÿôÿýÿöÿÿ÷ÿÿÿ÷ÿÿÿýÿÿÿþÿ ÿÿÿÿîÿÿúÿÿîÿÿýÿýÿöÿÿøÿÿÿ‚ÿ‚ÿ‚ÿ£ÿû¿ÿþàÿûÝÿø‚ÿ‚ÿ‚ÿ‚ÿãÿ ÿÿÿëÿÿÿëÿÿÿýÿÿñÿÿýÿÿÿñÿÿÿýÿÿõÿÿÿöÿÿÙÿÿÿþÿ ÿÿÿÿîÿÿþÿÿÿÿîÿÿþÿÿÿöÿÿøÿÿþÿ‚ÿ‚ÿ‚ÿ£ÿû¿ÿþàÿûÝÿø‚ÿ‚ÿ‚ÿ‚ÿãÿ ÿÿÿëÿÿÿëÿÿÿýÿÿôÿÿÿåÿÿÿýÿÿõÿÿÿöÿÿÙÿÿÿþÿÿÿêÿÿþÿþÿÿðÿÿÿþÿ ÿÿÿÿýÿÿÿøÿÿþÿÿ‚ÿ‚ÿ‚ÿ¦ÿû¿ÿþàÿûÝÿø‚ÿ‚ÿ‚ÿ‚ÿãÿ ÿÿÿëÿÿÿëÿÿÿýÿÿôÿÿÿÙÿÿøÿ ÿÿÿöÿÿÿÜÿÿÿþÿÿÿêÿþÿþ ÿÿÿÿóÿÿÿþÿÿÿùÿÿÿøÿÿþÿÿ‚ÿ‚ÿ‚ÿ¦ÿû¿ÿþãÿøÝÿø‚ÿ‚ÿ‚ÿ‚ÿãÿ ÿÿÿÿñÿ ÿÿÿëÿÿÿýÿÿôÿÿÿËÿ ÿÿÿÿ÷ÿÿÿÜÿÿÿþÿÿÿêÿÿýÿÿÿÿÿöÿÿÿþÿÿÿèÿÿþÿÿ‚ÿ‚ÿ‚ÿ¦ÿû¼ÿþéÿøÚÿø‚ÿ‚ÿ‚ÿ‚ÿãÿ ÿÿÿÿñÿ ÿÿÿßÿÿÿ÷ÿÿÿËÿ ÿÿÿÿ÷ÿÿÿÜÿÿÿþÿÿÿêÿýÿÿÿÿþÿÿöÿÿÿþÿÿÿèÿÿþÿÿ‚ÿ‚ÿ‚ÿ¦ÿû¹ÿàÚÿø‚ÿ‚ÿ‚ÿ‚ÿãÿ ÿÿÿÿñÿ ÿÿÿÿâÿÿÿ÷ÿÿÿËÿ ÿÿÿÿ÷ÿÿÿÜÿÿÿûÿÿêÿýÿÿÿÿþÿÿöÿÿÿþÿÿÿèÿÿþÿÿ‚ÿ‚ÿ‚ÿ¦ÿû¶ÿéÔÿø‚ÿ‚ÿ‚ÿ‚ÿãÿ ÿÿÿÿñÿÿÿÜÿÿÿøÿÿÿÿËÿ ÿÿÿÿ÷ÿÿÿåÿÿýÿÿÿûÿÿÿðÿÿýÿÿÿÿþÿÿöÿÿÿþÿÿÿçÿýÿÿ‚ÿ‚ÿ‚ÿ¦ÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿãÿÿèÿÿÿÜÿÿÿøÿ ÿÿÿÿýÿÿÚÿÿÿÿÿÿ÷ÿÿÿúÿÿÿôÿÿýÿÿøÿÿÿðÿÿýÿÿÿÿýÿÿöÿÿÿþÿÿÿçÿþÿþÿÿ‚ÿ‚ÿ‚ÿ©ÿû›ÿþÚÿø‚ÿ‚ÿ‚ÿ‚ÿæÿÿÿèÿÿÿËÿ ÿÿÿÿýÿÿÿôÿÿïÿÿÿÿÿÿ÷ÿÿÿúÿÿñÿ ÿÿÿÿøÿ ÿÿÿÿïÿÿüÿþÿþÿöÿÿÿþÿÿÿåÿÿþÿÿ‚ÿ‚ÿ‚ÿ©ÿû¿ÿþàÿþÚÿø‚ÿ‚ÿ‚ÿ‚ÿæÿÿÿèÿÿÿÎÿÿÿÿÿÿýÿÿÿôÿÿïÿÿÿÿÿÿ÷ÿÿÿúÿÿñÿ ÿÿÿÿøÿ ÿÿÿÿïÿÿüÿþÿþÿÿùÿÿÿþÿÿÿÿæÿÿþÿÿóÿ‚ÿ‚ÿ‚ÿ¹ÿû¿ÿþÝÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿæÿÿÿÇÿÿÿìÿÿÿÿÿÿÿÿÿôÿÿúÿÿûÿÿÿÿÿÿ÷ÿÿÿúÿÿñÿ ÿÿÿÿøÿ ÿÿÿÿòÿÿÿüÿÿýÿÿùÿÿÿþÿÿöÿÿÿõÿÿþÿÿùÿÿÿ‚ÿ‚ÿ‚ÿ¹ÿû¿ÿþàÿûÝÿø‚ÿ‚ÿ‚ÿ‚ÿæÿÿÿÇÿÿÿìÿÿÿÿÿÿÿÿÿôÿÿúÿÿûÿÿÿÿÿÿ÷ÿÿÿúÿÿñÿ ÿÿÿÿøÿ ÿÿÿÿõÿÿþÿÿ÷ÿÿÿùÿÿÿýÿÿöÿÿòÿÿþÿÿùÿ ÿÿÿ‚ÿ‚ÿ‚ÿ¼ÿûÅÿÑÝÿø‚ÿ‚ÿ‚ÿ‚ÿæÿÿÿâÿÿÿîÿÿÿïÿÿÿÿÿÿÿÿÿÿøÿÿÿÿúÿÿþÿÿÿÿÿÿÿôÿÿúÿÿñÿ ÿÿÿÿøÿ ÿÿÿÿòÿÿÿ÷ÿÿÿùÿÿÿý ÿÿÿÿÿýÿÿìÿÿùÿ ÿÿÿ‚ÿ‚ÿ‚ÿ¼ÿûÅÿÔÚÿø‚ÿ‚ÿ‚ÿ‚ÿæÿÿÿýÿÿëÿÿÿîÿÿÿþÿÿ÷ÿÿÿÿÿÿÿÿÿÿûÿ ÿÿÿÿúÿÿþÿÿÿÿÿÿÿôÿÿúÿÿñÿ ÿÿÿÿøÿÿþÿÿÿòÿÿÿ÷ÿÿÿñÿÿÿÿÿÿýÿÿìÿÿÿüÿ ÿÿÿ‚ÿ‚ÿ‚ÿ¼ÿû¿ÿþ¶ÿø‚ÿ‚ÿ‚ÿ‚ÿæÿÿÿýÿÿëÿÿÿîÿÿÿýÿÿÿÿÿÿÿÿúÿÿÿÿÿÿÿÿþÿÿÿúÿÿÿýÿÿÿÿÿÿèÿÿñÿÿÿïÿÿÿôÿÿÿôÿÿþÿñÿÿÿÿÿÿýÿÿìÿÿÿüÿ ÿÿÿ‚ÿ‚ÿ‚ÿ¼ÿû¿ÿþ¶ÿø‚ÿ‚ÿ‚ÿ‚ÿæÿÿÿýÿÿëÿÿÿîÿÿÿýÿÿÿÿÿÿÿ÷ÿÿþÿÿÿÿÿÿÿÿÿúÿÿýÿÿÿÿÿÿÿèÿÿñÿÿÿïÿÿÿôÿÿÿñÿÿÿôÿÿÿÿÿÿýÿÿôÿÿÿýÿÿüÿ ÿÿÿ‚ÿ‚ÿ‚ÿ¼ÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿÚÿÿñÿýÿÿÿîÿÿÿýÿÿÿÿÿÿôÿÿÿþÿÿÿÿÿÿÿùÿÿý ÿÿÿÿßÿÿñÿÿÿïÿÿÿôÿÿÿÿïÿÿôÿÿÿÿÿÿÿÿÿñÿÿýÿÿüÿ ÿÿÿ‚ÿ‚ÿ‚ÿ¼ÿû˜ÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿÚÿÿñÿ ÿÿÿÿîÿþÿþÿÿÿÿýÿÿÿïÿÿÿÿþÿÿÿÿÿÿÿÿÿý ÿÿÿÿÜÿÿñÿÿÿïÿÿÿ÷ÿ ÿÿÿÿ÷ÿÿþÿÿÿ÷ÿÿÿÿÿÿÿÿÿñÿÿþÿÿöÿÿ‚ÿ‚ÿ‚ÿ¼ÿû˜ÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿÚÿÿñÿ ÿÿÿÿîÿþÿþÿÿÿÿþÿÿÿïÿÿÿÿþÿÿÿÿýÿÿÿÿÿÿÿÿÿÜÿÿñÿÿÿïÿÿÿ÷ÿÿÿóÿÿþÿÿÿ÷ÿÿÿÿÿÿÿÿÿñÿÿþÿÿöÿÿ‚ÿ‚ÿ‚ÿ¼ÿû¼ÿÚÝÿø‚ÿ‚ÿ‚ÿ‚ÿÚÿÿñÿÿýÿÿïÿÿþÿÿÿÿÿÿèÿÿÿ÷ÿÿýÿÿÿÿÿÿÿÿßÿÿÿîÿÿïÿÿÿ÷ÿÿÿÿôÿÿûÿÿÿýÿÿÿÿÿÿÿÿÿÿñÿÿþÿÿöÿÿ‚ÿ‚ÿ‚ÿ¼ÿû¿ÿ×Ýÿø‚ÿ‚ÿ‚ÿ‚ÿÚÿÿÿôÿÿýÿÿïÿÿþÿÿÿÿÿÿ÷ÿÿÿ÷ÿÿ÷ÿÿÿþÿÿÿÿÿÿåÿÿýÿÿÿîÿÿÿñÿýÿúÿ ÿÿÿÿôÿÿÿþÿ ÿÿÿÿýÿÿüÿ ÿÿÿÿñÿÿþÿÿ‚ÿ‚ÿ‚ÿ¬ÿû¿ÿøãÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿÚÿÿÿôÿÿýÿÿïÿÿþÿÿÿÿÿÿ÷ÿÿÿ÷ÿÿ÷ÿÿÿþÿÿÿÿÿÿåÿÿýÿÿÿîÿÿÿòÿÿþÿÿýÿ ÿÿÿÿôÿÿÿþÿ ÿÿÿÿþÿùÿ ÿÿÿÿñÿÿþÿÿÿ‚ÿ‚ÿ£ÿû¿ÿûàÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿæÿÿÿýÿÿÿ÷ÿÿÿýÿÿïÿÿþÿÿÿÿÿÿ÷ÿÿôÿÿ÷ÿÿÿþÿÿþ ÿÿÿÿúÿÿñÿÿÿÿÿÿëÿÿñÿýÿÿýÿ ÿÿÿÿôÿÿÿþÿÿÿÿÿÿùÿ ÿÿÿÿñÿÿÿýÿÿÿ‚ÿ‚ÿ£ÿû¿ÿû¹ÿø‚ÿ‚ÿ‚ÿ‚ÿÿëÿÿÿþÿÿÿöÿÿÿýÿÿòÿÿþÿÿùÿÿ÷ÿÿåÿÿÿûÿÿÿÿ÷ÿÿñÿÿÿÍÿþÿþÿÿÿÿÿÿÿôÿÿÿûÿ ÿÿÿÿùÿ ÿÿÿÿñÿÿÿýÿÿ“ÿÿÿ‚ÿ‚ÿ¦ÿû¼ÿþàÿþÝÿø‚ÿ‚ÿ‚ÿ…ÿÿÿëÿÿýÿÿÿÿÿùÿÿÿýÿÿÿõÿÿþÿÿùÿÿ÷ÿÿåÿÿôÿÿ÷ÿÿñÿÿÿËÿÿþÿÿÿÿÿÿÿôÿÿÿûÿ ÿÿÿöÿ ÿÿÿÿñÿÿÿý ÿÿÿÿÿšÿÿÿ‚ÿ‚ÿ¦ÿû¹ÿþãÿþÝÿø‚ÿ‚ÿ‚ÿ…ÿ ÿÿÿîÿÿýÿÿÿÿÿùÿÿÿýÿÿÿõÿÿþÿÿùÿÿ÷ÿÿÓÿÿ÷ÿÿñÿÿÿÈÿÿÿþ ÿÿÿÿÿôÿÿÿúÿýÿóÿ ÿÿÿÿñÿÿÿý ÿÿÿÿÿšÿ ÿÿÿ‚ÿ‚ÿ©ÿû¿ÿ×Ýÿø‚ÿ‚ÿ‚ÿ…ÿ ÿÿÿîÿÿýÿÿÿýÿÿÿÿÿÿÿÿýÿÿÿõÿÿþÿöÿÿúÿÿÿÇÿÿÿñÿÿÿÈÿÿÿÿÿÿÿÿôÿÿÿúÿÿÿôÿÿÿëÿÿÿþÿ ÿÿÿÿšÿÿÿ‚ÿ‚ÿ¦ÿû¿ÿ×Ýÿø‚ÿ‚ÿ‚ÿ…ÿ ÿÿÿîÿÿýÿÿÿÿýÿÿÿÿÿÿÿýÿÿÿõÿÿÿöÿÿÿýÿÿÿÇÿÿÿñÿÿÿÈÿ ÿÿÿÿýÿÿôÿÿÿúÿÿÿôÿÿÿëÿÿÿþÿÿÿÿÿÿÿÿ£ÿÿ‚ÿ‚ÿ£ÿû¼ÿÚÝÿø‚ÿ‚ÿ‚ÿÊÿÿÿÄÿ ÿÿÿîÿý ÿÿÿÿÿýÿÿÿÿÿÿÿìÿÿþÿÿöÿÿÿýÿÿÿÇÿÿÿîÿÿ¸ÿÿôÿÿÿúÿÿÿÖÿÿÿþÿÿÿÿÿÿÿÿ£ÿÿ‚ÿ‚ÿ£ÿû¼ÿþàÿþÝÿø‚ÿ‚ÿ‚ÿÊÿÿÿÄÿ ÿÿÿîÿý ÿÿÿÿÿÿýÿÿÿÿÿÿìÿÿþÿÿöÿÿÿýÿÿÿÇÿÿÿîÿÿÿ»ÿÿôÿÿÿúÿÿÿÖÿÿÿþÿÿÿÿÿÿÿÿ£ÿÿ‚ÿ‚ÿ£ÿû˜ÿþÝÿø‚ÿ‚ÿ‚ÿÊÿÿÿÄÿ ÿÿÿîÿýÿÿñÿ ÿÿÿÿìÿÿþÿóÿÿÿýÿÿÿôÿÿÙÿÿÿîÿ ÿÿÿÍÿÿúÿÿÿôÿÿÿúÿÿÿÖÿÿÿþÿÿÿÿÿÿÿÿ¦ÿÿÿ‚ÿ‚ÿ£ÿû‚ÿðÿø‚ÿ‚ÿ‚ÿÊÿÿÿÄÿ ÿÿÿîÿýÿîÿ ÿÿÿÿìÿÿþÿçÿÿÿôÿÿ÷ÿåÿÿÿîÿ ÿÿÿÐÿÿÿåÿÿÿúÿÿÿËÿÿÿÿÿÿÿÿ¦ÿÿÿ‚ÿ‚ÿ£ÿûÑÿþËÿþÝÿø‚ÿ‚ÿ‚ÿÊÿ ÿÿÿÇÿÿéÿÿÿîÿÿÿÿÿÿòÿÿþÿÿçÿÿÿôÿÿÿúÿÿèÿÿÿîÿ ÿÿÿÐÿÿÿåÿÿÿúÿÿÿËÿÿÿÿÿÿÿÿ¦ÿÿÿ‚ÿ‚ÿ£ÿûÑÿþËÿþÝÿø‚ÿ‚ÿ‚ÿèÿåÿ ÿÿÿÿÊÿÿëÿýÿÿëÿ ÿÿÿÿòÿ ÿÿÿçÿÿÿôÿÿÿúÿÿôÿÿÿýÿÿÿëÿÿÍÿÿÿåÿÿÿúÿÿÿËÿÿÿÿÿÿÿÿ¦ÿ ÿÿÿÿ‚ÿ‚ÿ©ÿûÑÿÅÝÿø‚ÿ‚ÿ‚ÿèÿÿèÿ ÿÿÿÿ¯ÿýÿÿèÿÿÿñÿ ÿÿÿÿèÿÿÿôÿÿÿýÿÿÿôÿÿÿýÿÿÿ²ÿÿÿÖÿÿÅÿÿÿüÿÿ¦ÿ ÿÿÿÿ‚ÿ‚ÿ©ÿûÑÿÅÝÿø‚ÿ‚ÿ‚ÿëÿÿÿèÿ ÿÿÿÿ°ÿÿþÿÿèÿÿÿÿÿÿÿþÿÿÿÿÿÿèÿÿÿôÿÿÿýÿÿÿôÿÿÿýÿÿÿ²ÿÿÿÖÿÿÇÿýÿÿüÿÿ¦ÿ ÿÿÿÿ‚ÿ‚ÿ©ÿûÑÿÅÝÿø‚ÿ‚ÿ‚ÿëÿ ÿÿÿëÿ ÿÿÿÿ°ÿÿþÿÿùÿÿòÿÿÿÿÿÿþÿÿÿÿÿÿèÿÿÿôÿÿÿýÿÿÿôÿÿÿýÿÿÿ²ÿÿÿ—ÿýÿÿüÿÿÁÿÿëÿ ÿÿÿÿîÿÿÿ‚ÿ‚ÿÄÿûÑÿûÑÿûÝÿø‚ÿ‚ÿ‚ÿëÿ ÿÿÿëÿ ÿÿÿÿ°ÿÿþÿÿùÿÿòÿÿÿÿÿÿþÿÿÿÿÿÿÓÿÿÿýÿÿÿôÿÿÿýÿÿÿ²ÿÿÿ—ÿýÿÿÿÿÿÿÄÿÿÿâÿÿîÿÿÿ‚ÿ‚ÿÄÿûÑÿþËÿþÝÿø‚ÿ‚ÿ‚ÿèÿÿÿëÿ ÿÿÿÿ°ÿÿþÿöÿÿòÿ ÿÿÿÿÿýÿÿüÿÿôÿÿÿèÿÿÿýÿÿÿôÿÿÿýÿÿÿ¯ÿÿúÿÿÿ¯ÿÿýÿýÿÿÿÿÿÿÁÿÿâÿÿîÿÿÿ‚ÿ‚ÿÄÿûÑÿþËÿþÝÿø‚ÿ‚ÿ‚ÿèÿÿÿëÿ ÿÿÿÿÄÿÿÿøÿÿþÿÿöÿÿúÿÿÿý ÿÿÿÿÿýÿÿüÿÿôÿÿÿåÿÿýÿÿÿñÿÿ£ÿÿúÿÿ¬ÿÿýÿÿýÿÿÿÿÿÿÄÿÿâÿÿîÿ ÿÿÿ‚ÿ‚ÿÇÿûÑÿþËÿþÝÿø‚ÿ‚ÿ‚ÿåÿÿëÿ ÿÿÿÿÍÿÿÿÿÿÿøÿÿþÿÿöÿÿÿýÿÿÿþÿÿÿÿÿÿÿüÿÿñÿÿåÿÿýÿÿÿñÿÿ£ÿÿúÿÿëÿÿÇÿÿøÿÿÿÿÿÿÿÄÿÿÿåÿÿÿñÿ ÿÿÿÿ‚ÿ‚ÿÊÿû‚ÿðÿø‚ÿ‚ÿ‚ÿåÿÿëÿ ÿÿÿÿîÿÿÿèÿÿÿÿÿÿøÿÿþÿÿöÿÿÿýÿÿÿþÿÿÿÿÿÿÿÿýÿÿñÿÿåÿÿýÿÿîÿÿÿ¦ÿÿúÿÿîÿÿÿÇÿÿÿûÿÿÿÿÿÿÿÄÿÿÿåÿÿÿñÿ ÿÿÿÿ‚ÿ‚ÿÊÿû‚ÿðÿø‚ÿ‚ÿ‚ÿåÿÿëÿ ÿÿÿÿîÿÿÿèÿÿýÿÿÿøÿÿþÿÿöÿÿÿýÿÿÿþÿÿÿÿÿÿÿÿýÿÿñÿÿÿèÿÿýÿÿîÿÿÿ¦ÿÿýÿÿÿîÿ ÿÿÿÿÍÿÿÿûÿÿÿÿÿÿÿÊÿ ÿÿÿÿåÿÿÿñÿ ÿÿÿÿ‚ÿ‚ÿÊÿû‚ÿðÿø‚ÿ‚ÿ‚ÿåÿÿîÿÿÿÿÿÿîÿÿåÿÿýÿÿÿøÿÿþÿóÿÿÿýÿÿÿûÿÿÿúÿÿýÿÿñÿ ÿÿÿÿîÿ ÿÿÿÿîÿÿÿ¦ÿÿýÿÿÿîÿÿÿÿÿÿÐÿÿÿûÿÿÿÀÿ ÿÿÿÿåÿÿÿôÿÿÿÿÿÿ‚ÿ‚ÿÊÿû‚ÿðÿø‚ÿ‚ÿ‚ÿîÿ ÿÿÿÿåÿÿÿñÿÿÿåÿÿýÿÿÿøÿÿÿóÿÿÿýÿÿÿ÷ÿÿÿúÿÿÿñÿ ÿÿÿÿîÿ ÿÿÿÿîÿÿÿ¦ÿÿýÿÿÿîÿÿÿÿÿÿÐÿÿÿûÿÿÿÀÿ ÿÿÿÿîÿÿýÿÿÿôÿÿÿÿÿÿ‚ÿ‚ÿÊÿû‚ÿðÿø‚ÿ‚ÿ‚ÿîÿ ÿÿÿÿåÿÿÿñÿÿÿåÿÿúÿÿøÿ ÿÿÿÿ÷ÿÿÿýÿÿÿ÷ÿÿÿúÿÿÿñÿ ÿÿÿÿîÿ ÿÿÿÿîÿ ÿÿÿ©ÿÿÿÿÿÿîÿÿÿÿÿÿÐÿÿÿûÿÿÿÀÿ ÿÿÿÿîÿÿýÿÿÿôÿÿÿÿÿÿ‚ÿ‚ÿÊÿû‚ÿðÿø‚ÿ‚ÿ‚ÿîÿ ÿÿÿÿâÿÿñÿÿÿåÿÿúÿÿûÿÿþ ÿÿÿÿ÷ÿÿÿýÿÿÿ÷ÿÿÿúÿÿÿîÿÿÿåÿÿÿîÿ ÿÿÿ©ÿÿÿÿÿÿëÿ ÿÿÿÍÿ ÿÿÿÿþÿÿÿÃÿ ÿÿÿÿîÿÿýÿÿÿôÿÿÿÿÿÿ‚ÿ‚ÿÊÿû‚ÿðÿø‚ÿ‚ÿ‚ÿîÿ ÿÿÿÿâÿÿñÿÿÿåÿÿúÿÿûÿÿþ ÿÿÿÿ÷ÿÿÿýÿÿôÿÿÿúÿÿÿîÿÿÿâÿÿëÿÿÿ ÿÿÿëÿ ÿÿÿÍÿ ÿÿÿÿþÿÿÿÃÿ ÿÿÿÿñÿÿÿýÿÿÿôÿÿÿÿÿÿÄÿÿÿ‚ÿÿû‚ÿðÿø‚ÿ‚ÿ‚ÿîÿÿÿÜÿÿñÿÿÿåÿÿúÿÿûÿÿÿÿÿÿ÷ÿÿÿýÿÿôÿÿÿúÿÿÿîÿÿÿ‚ÿÝÿÿÿëÿ ÿÿÿÊÿ ÿÿÿûÿÿÃÿ ÿÿÿÿñÿÿÿýÿÿÿôÿÿÿÿÿÿÄÿÿÿ‚ÿÿû‚ÿðÿø‚ÿ‚ÿ‚ÿîÿÿÿÇÿ ÿÿÿÿëÿÿúÿÿûÿÿÿÿÿÿ÷ÿÿÿýÿÿôÿÿÿúÿÿÿëÿ‚ÿÚÿÿÿëÿ ÿÿÿÊÿÿÿøÿÿÿÆÿ ÿÿÿÿñÿÿÿèÿÿÿÿÿÿÄÿÿÿ‚ÿÿû‚ÿðÿø‚ÿ‚ÿ‚ÿîÿÿÿæÿÿçÿ ÿÿÿÿëÿÿþÿÿÿÿþÿÿþ ÿÿÿÿñÿ ÿÿÿÿôÿÿÿ‚ÿ³ÿÿåÿÿÇÿÿÿøÿ ÿÿÿÿÊÿ ÿÿÿÿñÿÿÿèÿÿÿÿÿÿÄÿÿÿ‚ÿÿû‚ÿðÿø‚ÿ‚ÿ‚ÿïÿÿÿÿéÿ ÿÿÿêÿ ÿÿÿÿëÿÿýÿÿÿÿÿÿÿÿÿÿñÿ ÿÿÿÿ‚ÿ¡ÿÿÿ•ÿÿþÿÿêÿÿÿëÿÿÿýÿÿñÿÿÿèÿÿÿÿÿÿÄÿÿ‚ÿÿû‚ÿðÿø‚ÿ‚ÿ‚ÿïÿÿÿÿéÿ ÿÿÿêÿ ÿÿÿÿîÿÿÿýÿÿÿÿÿÿÿÿÿÿñÿýÿÿÿ‚ÿ¡ÿÿÿ•ÿÿþÿÿêÿÿÿëÿÿÿèÿÿÿõÿÿÿÿÿÿüÿÿÿÇÿÿÿ‚ÿÿû‚ÿðÿø‚ÿ‚ÿ‚ÿòÿÿÿÿÿÿïÿÿÿÿÿÿíÿ ÿÿÿÿîÿÿýÿÿÿÿþÿÿúÿÿÿëÿÿÿ‚ÿ¡ÿÿÿ’ÿÿÿêÿ ÿÿÿîÿÿÿèÿÿÿøÿÿÿÿÿÿÿÿÿýÿÿÇÿÿÿ‚ÿÿû‚ÿðÿø‚ÿ‚ÿ‚ÿòÿÿÿÿÿÿïÿÿÿÿÿÿÿÿñÿÿýÿÿïÿÿÿþÿÿÿÿÿÿúÿÿÿëÿÿÿ‚ÿ¡ÿÿÿÿÿêÿ ÿÿÿîÿÿÿéÿÿÿýÿÿÿÿÿÿÿÿÿÿüÿÿÇÿÿÿ‚ÿÿû‚ÿðÿø‚ÿ‚ÿ‚ÿòÿÿÿÿþ ÿÿÿÿõÿÿÿÿÿÿÿÿÿôÿÿýÿÿïÿÿÿþ ÿÿÿÿÿ÷ÿÿÿëÿÿÿ‚ÿ‚ÿ¦ÿÿçÿÿÿîÿÿÿéÿÿÿÿÿÿÿÿÿúÿÿÿüÿÿÇÿÿÿèÿÿ‚ÿ«ÿû‚ÿðÿø‚ÿ‚ÿ‚ÿòÿÿÿþ ÿÿÿÿÿøÿ ÿÿÿÿþ ÿÿÿÿÿûÿ ÿÿÿÿýÿÿïÿÿþÿÿýÿÿôÿÿÿÇÿÿ‚ÿ‚ÿÇÿÿÿçÿÿîÿÿÿìÿÿÿÿÿÿÿÿÿÿÿûÿÿÿ½ÿÿÿèÿÿ‚ÿ«ÿû‚ÿðÿø‚ÿ‚ÿ‚ÿòÿÿþÿÿÿÿÿÿøÿ ÿÿÿÿþÿ ÿÿÿÿý ÿÿÿÿÿúÿÿÿõÿÿÿþÿÿíÿÿÿÍÿýÿÿ‚ÿ‚ÿÇÿÿÿçÿÿîÿÿÿìÿÿÿöÿþÿÿõÿÿÿÿÁÿ ÿÿÿÿñÿÿÿ‚ÿ«ÿû‚ÿðÿø‚ÿ‚ÿ‚ÿòÿÿþÿÿÿÿÿÿøÿ ÿÿÿÿþÿ ÿÿÿÿýÿÿÿÿÿÿýÿÿÿõÿÿÿþÿêÿÿÿÓÿÿÿÿÿÿ‚ÿ‚ÿÇÿÿÿçÿÿÔÿÿþÿÿöÿÿÿõÿÿÿäÿÿÿåÿÿýÿÿñÿÿÿ‚ÿ«ÿû‚ÿðÿø‚ÿ‚ÿ‚ÿñÿýÿÿÿÿÿÿÿûÿ ÿÿÿÿþÿ)ÿÿÿÿÿÿÿÿÿÿÿÿÿÿõÿÿþÿÿêÿÿÿÓÿÿÿÿÿÿ‚ÿ‚ÿÇÿÿÿçÿÿâÿÿÿûÿ ÿÿÿÿ÷ÿÿÿúÿÿýÿÿäÿÿÿåÿÿýÿÿñÿ ÿÿÿÿ‚ÿ±ÿû‚ÿðÿø‚ÿ‚ÿ‚ÿòÿÿÿýÿ ÿÿÿÿûÿ ÿÿÿÿûÿÿÿÿÿÿÿþÿÿÿÿÿÿÿõÿÿþÿÿêÿÿÐÿÿÿÿÿÿ‚ÿ‚ÿÇÿÿþÿÿêÿÿâÿÿÿþÿ ÿÿÿóÿÿÿúÿÿÿýÿäÿÿÿåÿÿýÿÿñÿ ÿÿÿÿ‚ÿ±ÿû‚ÿðÿø‚ÿ‚ÿ‚ÿòÿÿÿýÿ ÿÿÿÿûÿ ÿÿÿÿ÷ÿÿþÿÿÿþÿÿÿÿÿÿÿõÿÿÿóÿÿÁÿ ÿÿÿ‚ÿ‚ÿÄÿÿþÿÿóÿúÿÿòÿÿÿÿþ ÿÿÿÿÿþÿÿÿðÿÿÿúÿÿÿýÿÿçÿÿâÿÿýÿÿÿôÿ ÿÿÿÿ‚ÿ±ÿû‚ÿðÿø‚ÿ‚ÿ‚ÿòÿÿÿýÿ ÿÿÿÿûÿ ÿÿÿÿ÷ÿÿõÿÿÿÿÿÿÿõÿÿÿóÿÿÁÿ ÿÿÿ‚ÿ‚ÿÄÿÿÿþÿóÿÿÿÿÿÿøÿÿÿÿþÿÿÿÿÿÿÿÿíÿÿÿúÿÿÿý ÿÿÿÿÿîÿÿÙÿÿÿôÿ ÿÿÿÿ‚ÿ±ÿû‚ÿðÿø‚ÿ‚ÿ‚ÿòÿÿÿúÿÿÿÿþÿÿÿÿÿÿ÷ÿÿõÿÿÿÿÿÿÿøÿÿþÿÿóÿÿÁÿ ÿÿÿ‚ÿ‚ÿÃÿþÿþÿóÿÿÿÿÿÿøÿÿÿþÿÿÿÿÿÿÿÿÿíÿÿÿúÿÿÿý ÿÿÿÿÿñÿ ÿÿÿÿßÿÿÿôÿ ÿÿÿÿ‚ÿ±ÿû‚ÿðÿø‚ÿ‚ÿ‚ÿòÿÿ÷ÿÿÿýÿÿÿÿÿÿ÷ÿÿ÷ÿÿý ÿÿÿÿÿøÿÿþÿÿóÿÿÁÿ ÿÿÿ‚ÿ‚ÿÃÿþÿþÿÿöÿÿÿÿÿÿûÿÿÿþÿÿÿÿÿÿÿÿÿÿêÿÿúÿÿÿþÿ ÿÿÿÿñÿ ÿÿÿÿßÿÿÿôÿ ÿÿÿÿ‚ÿ±ÿû‚ÿðÿø‚ÿ‚ÿ‚ÿõÿÿÿ÷ÿÿÿýÿÿÿÿÿÿ÷ÿÿÿúÿÿý ÿÿÿÿõÿ ÿÿÿÿôÿÿÿÁÿÿ‚ÿ‚ÿÀÿÿýÿÿöÿÿïÿ ÿÿÿÿýÿÿÿÿþÿÿçÿÿúÿÿÿþÿ ÿÿÿÿñÿÿÿÿÿÿâÿÿÿýÿùÿ ÿÿÿÿ‚ÿ±ÿû‚ÿðÿø‚ÿ‚ÿ‚ÿõÿÿÿ÷ÿÿÿýÿÿÿÿÿÿ÷ÿÿÿúÿÿýÿÿñÿ ÿÿÿÿôÿÿÿ‚ÿ‚ÿ‚ÿõÿÿþÿöÿÿïÿÿÿÿÿÿûÿ ÿÿÿÿúÿÿÿôÿÿÿýÿÿÿþÿ ÿÿÿÿñÿÿÿÿÿÿâÿý ÿÿÿÿüÿÿýÿÿÿëÿÿ‚ÿÏÿû‚ÿðÿø‚ÿ‚ÿ‚ÿõÿ ÿÿÿÿûÿÿÿýÿÿÿðÿÿÿúÿÿý ÿÿÿÿõÿ ÿÿÿÿôÿÿÿ‚ÿ‚ÿ‚ÿòÿÿùÿÿÿïÿÿÿÿÿÿ÷ÿÿ÷ÿÿÿôÿÿÿýÿÿÿþÿ ÿÿÿÿñÿÿÿÿÿÿãÿÿÿÿÿÿüÿÿýÿÿÿëÿÿÿ‚ÿÒÿû‚ÿðÿø‚ÿËÿÿÿ‚ÿ´ÿ ÿÿÿÿûÿÿþÿÿÿÿÿÿñÿÿÿúÿÿþÿÿÿ÷ÿÿÿÿÿÿôÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿûÿÿÿüÿÿÿòÿÿÿÿÿÿÿ÷ÿÿ÷ÿÿÿôÿÿÿýÿÿøÿÿÿÿñÿÿÿÿÿÿæÿÿÿÿÿÿÿÿÿÿÿýÿÿÿëÿÿÿ‚ÿÒÿû‚ÿðÿø‚ÿËÿÿÿ‚ÿ´ÿ ÿÿÿÿûÿÿþ ÿÿÿÿíÿÿÿýÿÿÿûÿÿÿúÿÿÿÿÿÿñÿ ÿÿÿÿ‚ÿ‚ÿ‚ÿûÿÿÿÿÿÿÿÿõÿÿÿüÿÿÿ÷ÿÿÿúÿÿÿôÿÿÿýÿÿøÿÿÿðÿÿÿÿÿÿîÿÿÿý ÿÿÿÿÿþ ÿÿÿÿÿýÿÿÿëÿÿÿ‚ÿÒÿû‚ÿðÿø‚ÿÌÿÿþÿÿÿ‚ÿºÿÿÿÿÿÿ÷ÿýÿÿêÿÿÿýÿÿÿûÿÿÿÿÿÿÿÿÿÿÿñÿ ÿÿÿ‚ÿ‚ÿ‚ÿõÿÿÿÿÿÿÿøÿ ÿÿÿüÿÿÿ÷ÿÿÿúÿÿñÿÿÿÿÿÿøÿÿÿðÿÿÿÿÿÿîÿÿÿý ÿÿÿÿûÿ ÿÿÿÿýÿÿÿèÿÿÿ‚ÿÕÿû‚ÿðÿø‚ÿÌÿ ÿÿÿÿ‚ÿºÿ ÿÿÿÿÇÿÿÿøÿ ÿÿÿÿüÿÿÿñÿ ÿÿÿ‚ÿ‚ÿ‚ÿõÿÿÿÿÿÿÿúÿýÿÿùÿÿÿ÷ÿÿÿúÿÿñÿÿÿÿÿÿøÿÿÿðÿÿÿýÿÿîÿÿý ÿÿÿÿÿøÿÿÿÿÿÿÿÿèÿÿÿ‚ÿÕÿû‚ÿðÿø‚ÿÌÿ ÿÿÿÿ‚ÿËÿýÿÿûÿ ÿÿÿÿÇÿÿÿøÿ ÿÿÿÿüÿÿÿñÿ ÿÿÿ‚ÿ‚ÿ‚ÿõÿÿÿÿÿÿ÷ÿýÿÿùÿÿÿ÷ÿÿÿúÿÿèÿÿÿõÿÿÿóÿÿúÿÿîÿÿý ÿÿÿÿÿøÿÿÿÿÿÿÿÿèÿÿÿ‚ÿÕÿû‚ÿðÿø‚ÿÌÿ ÿÿÿ‚ÿÍÿ ÿÿÿÿþÿÿÿÿÿÿèÿÿÿèÿÿôÿýÿÿùÿÿÿîÿÿ‚ÿ‚ÿ‚ÿúÿÿÿþÿ ÿÿÿÿøÿÿÿöÿÿñÿÿúÿÿèÿÿÿõÿ ÿÿÿöÿÿúÿÿîÿÿýÿÿîÿÿÿüÿÿèÿÿÿ‚ÿÕÿû‚ÿðÿø‚ÿÏÿ ÿÿÿÿ÷ÿÿ‚ÿÜÿ ÿÿÿÿþÿÿÿÿÿÿèÿÿÿèÿÿôÿþÿÿ÷ÿÿ‚ÿ‚ÿ‚ÿßÿÿÿþÿ ÿÿÿ÷ÿÿÿöÿÿñÿÿúÿÿèÿÿñÿýÿÿÿÿÿÿöÿÿîÿýÿÿëÿÿÿÿÿÿÿèÿÿÿ‚ÿÕÿû‚ÿðÿø‚ÿÏÿ ÿÿÿÿ÷ÿÿÿ‚ÿßÿ ÿÿÿÿþÿÿÿÿÿÿèÿÿÿèÿÿõÿ ÿÿÿÿúÿÿ‚ÿ‚ÿ‚ÿßÿÿÿøÿÿÿÿÿÿÿÿÿúÿÿÿèÿÿÿÓÿÿýÿÿÿÿÿÿÿÿýÿÿîÿýÿÿèÿÿÿçÿ ÿÿÿÿ‚ÿÕÿû‚ÿðÿø‚ÿÏÿ ÿÿÿÿúÿ ÿÿÿ‚ÿßÿÿÿÿÿÿý ÿÿÿÿÿèÿÿÿèÿÿòÿÿÿúÿÿÿ‚ÿ‚ÿ‚ÿßÿÿÿøÿÿÿÿÿÿÿÿÿúÿÿÿèÿÿÿÓÿÿþÿþÿÿÿÿÿÿÿÿÿÿïÿÿÿåÿ ÿÿÿêÿ ÿÿÿÿ‚ÿÕÿû‚ÿðÿø‚ÿÏÿ ÿÿÿÿúÿ ÿÿÿ‚ÿýÿÿÿëÿ ÿÿÿÿýÿÿÿÿÿÿîÿýÿÿÿëÿÿÿñÿþÿúÿÿÿ‚ÿ‚ÿ‚ÿÜÿÿúÿÿýÿÿüÿþÿÿúÿÿÿèÿÿÿÐÿÿþÿÿÿþÿÿÿÿÿÿÿïÿÿÿâÿÿÿêÿ ÿÿÿÿ‚ÿÕÿû‚ÿðÿø‚ÿÏÿÿÿÿÿÿÿþÿ ÿÿÿÿ‚ÿ ÿÿÿÿîÿ ÿÿÿÿýÿÿÿÿÿÿôÿÿÿýÿÿëÿ ÿÿÿñÿÿÿýÿÿÿ‚ÿ‚ÿ‚ÿÜÿÿåÿÿúÿÿÿèÿÿÿÐÿÿõÿÿÿÿÿÿÿÿõÿÿþÿçÿÿûÿÿÿðÿÿÿÿÿÿ‚ÿÕÿû‚ÿðÿø‚ÿÏÿÿýÿÿÿÿþÿ ÿÿÿÿ‚ÿ ÿÿÿÿîÿ ÿÿÿÿý ÿÿÿÿÿîÿ ÿÿÿÿëÿÿÿîÿÿÿ‚ÿ‚ÿ‚ÿÐÿÿåÿÿúÿÿÿëÿÿÿ¶ÿÿÿñÿÿþÿÿêÿÿÿøÿÿÿóÿÿÿýÿÿ‚ÿÕÿû‚ÿðÿø‚ÿÏÿÿýÿÿÿýÿ ÿÿÿÿ‚ÿ ÿÿÿÿîÿÿÿýÿý ÿÿÿÿÿîÿ ÿÿÿÿÐÿÿÿ‚ÿ‚ÿ‚ÿÐÿÿÿèÿÿÿýÿÿÿëÿÿÿ¾ÿøÿ ÿÿÿÿúÿ ÿÿÿÿôÿÿÿÿÿÿøÿ ÿÿÿöÿÿÿýÿÿÿ‚ÿØÿû‚ÿðÿø‚ÿÏÿÿýÿÿÿÿÿÿÿÿÿ‚ÿ ÿÿÿÿîÿÿûÿÿÿÿÿÿÿîÿ ÿÿÿÿÐÿÿÿ‚ÿ‚ÿ‚ÿÐÿÿÿèÿÿÿßÿÿÿ¾ÿÿûÿ ÿÿÿÿýÿÿÿÿÿÿôÿÿÿÿÿÿøÿ ÿÿÿöÿÿÿýÿÿÿ‚ÿØÿû‚ÿðÿø‚ÿÏÿÿýÿÿÿÿÿÿÿÿýÿÿÿˆÿ ÿÿÿÿîÿÿûÿÿÿÿÿÿÿëÿ ÿÿÿÐÿÿÿ‚ÿ‚ÿ‚ÿÐÿÿÿèÿÿÿßÿÿ»ÿÿøÿÿþÿÿÿÿÿÿÿÿÿôÿ ÿÿÿÿõÿÿþÿÿÿùÿÿúÿÿÿëÿåÿÿ’ÿû‚ÿðÿø‚ÿÏÿÿýÿÿÿÿÿÿÿÿýÿÿÿˆÿÿÿÿÿÿôÿÿÿý ÿÿÿÿÿúÿëÿÿÿÊÿÿ‚ÿ‚ÿ‚ÿÍÿÿèÿÿÿ”ÿÿõÿÿþÿÿÿüÿÿÿôÿ ÿÿÿÿôÿÿÿýÿÿÿÿÿÿÿÿâÿÿèÿ ÿÿÿ˜ÿû‚ÿðÿø‚ÿÒÿÿÿúÿÿÿÿÿÿÿýÿÿ‡ÿÿÿÿÿÿôÿýÿÿÿÿÿÿÿ£ÿÿÿ‚ÿ‚ÿ‚ÿÐÿ ÿÿÿÿñÿÿÿ—ÿÿÿâÿÿñÿ ÿÿÿÿñÿÿýÿÿÿÿÿÿÿÿçÿÿÿèÿ ÿÿÿÿ›ÿû‚ÿðÿø‚ÿÒÿÿÿúÿ ÿÿÿÿýÿÿÿ‡ÿ ÿÿÿÿòÿÿÿÿÿÿÿÿÿ£ÿÿÿ‚ÿ‚ÿ‚ÿÐÿ ÿÿÿÿîÿÿÿ£ÿÿýÿÿÿÊÿ ÿÿÿñÿÿþÿÿÿÿÿÿÿÿçÿ ÿÿÿÿñÿÿÿÿÿÿ›ÿû‚ÿðÿø‚ÿÒÿÿÿúÿÿÿÿÿÿþÿÿÿ‚ÿìÿÿÿÿÿÿÿÿÿÿ ÿÿÿ‚ÿ‚ÿ‚ÿÐÿÿÿëÿÿÿ£ÿÿýÿÿÿôÿÿÿßÿ ÿÿÿñÿÿÿúÿÿýýÿÿÿêÿÿÿÿÿÿôÿÿÿÿÿÿ›ÿû‚ÿðÿø‚ÿÒÿÿÿúÿÿÿÿÿÿþÿÿÿ‚ÿìÿÿÿÿÿÿÿÿÿÿÿ£ÿÿ‚ÿ‚ÿ‚ÿ¯ÿÿ ÿ ÿÿÿÿñÿÿÿÜÿÿîÿÿÿúÿÿÿþÿ ÿÿÿíÿÿÿÿÿÿþÿÿüÿÿÿÿÿÿ›ÿû‚ÿðÿø‚ÿÒÿÿÿ÷ÿ ÿÿÿÿþÿÿÿ‚ÿïÿ ÿÿÿÿôÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÞÿ ÿÿÿÿñÿÿÿÄÿÿÿúÿÿÿûÿÿÿíÿÿýÿÿÿýÿÿÿÿÿÿÿÿÿÿ›ÿû‚ÿðÿø‚ÿÒÿÿÿÿ÷ÿÿÿûÿ ÿÿÿÿŒÿÿÿÿþÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿËÿ ÿÿÿÿñÿÿÿÄÿÿÿúÿÿÿøÿÿÿðÿÿýÿÿýÿÿÿÿÿÿÿýÿÿÿ›ÿû‚ÿðÿø‚ÿÒÿÿóÿÿÿûÿ ÿÿÿÿ¦ÿéÿÿÿÿþÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÅÿ ÿÿÿñÿÿÿÄÿÿÿúÿÿÿøÿÿÿóÿÿÿýÿÿýÿÿÿÿÿÿÿýÿÿÿ›ÿû‚ÿðÿø‚ÿÕÿÿÿâÿÿÿÿ©ÿÿÿïÿÿÿÿþÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÃÿÿÿëÿÿÿýÿÿÐÿÿÿèÿýÿÿöÿÿÿýÿýÿÿúÿ ÿÿÿÿýÿÿ›ÿû‚ÿðÿø‚ÿÕÿÿÿâÿÿÿÿ¬ÿ ÿÿÿïÿÿÿþÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿŸÿÿÿÿÿÿÍÿÿèÿýÿÿÿùÿÿÿþÿ ÿÿÿ÷ÿÿÿüÿÿÿžÿû‚ÿðÿø‚ÿÕÿÿÿâÿÿÿ«ÿ ÿÿÿÿõÿÿÿþÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿŸÿÿÿÿÿÿÍÿÿÿëÿÿýÿÿÿüÿÿÿþÿ ÿÿÿÿúÿýÿÿÿÿÿÿÿžÿû‚ÿðÿø‚ÿÕÿÿÿâÿÿÿ«ÿ ÿÿÿÿõÿÿÿþÿÿüÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿŸÿÿÿÿÿÿÍÿÿÿëÿÿýÿÿÿÿÿÿÿÿþÿþ ÿÿÿÿúÿÿýÿÿÿÿÿÿžÿû‚ÿðÿø‚ÿÕÿÿÿâÿÿÿ«ÿ ÿÿÿÿõÿÿþÿÿöÿÿúÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¨ÿ ÿÿÿÿÊÿÿèÿÿýÿÿÿÿÿÿÿý ÿÿÿÿÿúÿÿýÿÿÿÿÿÿèÿÿ¼ÿû‚ÿðÿø‚ÿÕÿÿÿâÿÿÿ¨ÿ ÿÿÿøÿÿþÿÿÿöÿÿýÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¨ÿ ÿÿÿÇÿÿèÿÿûÿÿÿÿÿÿÿÿÿÿÿúÿÿÿýÿÿÿÿÿÿðÿÿÿÁÿþÿû‚ÿðÿø‚ÿÕÿÿÿâÿÿÿ©ÿ ÿÿÿÿøÿ ÿÿÿóÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿâÿÿèÿÿøÿÿÿÿÿÿÿÿÿÿýÿÿÿþÿÿÿÿÿÿÿÿùÿ ÿÿÿÿåÿÿåÿÿÿù‚ÿðÿø‚ÿÕÿÿÿâÿÿÿ¬ÿÿþ ÿÿÿÿÿûÿ ÿÿÿÿôÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÄÿÿÿ÷ÿÿôÿÿ÷ÿõÿÿÿÿÿÿüÿÿýÿÿÿëÿÿÿåÿÿÿù‚ÿðÿø‚ÿÕÿÿÿßÿÿÿÿ³ÿÿÿþÿÿÿÿÿÿÿÿÿÿÿôÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÄÿÿÿåÿÿÿìÿÿÿÿþÿÿÿÿÿÿýÿÿÿëÿ ÿÿÿèÿÿÿù‚ÿðÿø‚ÿÕÿÿÜÿÿÿ¯ÿ#ÿÿÿÿÿÿÿÿÿÿÿÿñÿ ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÁÿÿÿåÿÿÿãÿÿþ ÿÿÿÿÿýÿÿÿîÿ ÿÿÿÿèÿÿÿù‚ÿðÿø‚ÿØÿÿÿÜÿÿÿ²ÿ ÿÿÿüÿýÿÿÿÿÿÿÿñÿ ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¾ÿÿÿ¼ÿ ÿÿÿÿýÿÿÿîÿ ÿÿÿÿâÿù‚ÿðÿø‚ÿØÿÿÿÜÿÿÿ²ÿÿÿôÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ ÿÿÿ¼ÿ ÿÿÿüÿÿÿîÿÿÿÜÿù‚ÿðÿø‚ÿØÿÿÿÙÿÿ²ÿÿñÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ ÿÿÿ¹ÿÿÿÿÿÿÿÿîÿÿÿÜÿù‚ÿðÿø‚ÿØÿÿÿÙÿÿÿöÿÿÿËÿÿÿîÿ ÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿÿ»ÿÿýÿÿÿÿÿÿÿñÿÿÙÿù‚ÿðÿø‚ÿØÿÿÿÙÿÿÿÿÿÿÿÿÿÿÿÎÿÿÿÿëÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿÿ»ÿÿÿý$ÿÿÿÿÿÿÿÿÿÿÿÿÿãÿÿúÿù‚ÿðÿø‚ÿíÿÿïÿÿÿØÿýÿÿÿÿÿÿÿÿÿÑÿ ÿÿÿÿîÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÚÿÿÿýÿÿøÿÿþÿÿÿÿÿÿÿÿÿÿÿòÿÿÿÿÿÿÿÿÿû‚ÿðÿø‚ÿðÿÿÿôÿÿÿÓÿÿÿÿÿÿÿÿÿÿÔÿ ÿÿÿêÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ×ÿ ÿÿÿÿôÿÿÿý<ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿû‚ÿðÿø‚ÿóÿ ÿÿÿÿ÷ÿÿÿÓÿ ÿÿÿÿþÿÿÿÐÿ ÿÿÿÿèÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÔÿ ÿÿÿÿñÿÿõÿ2ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿû‚ÿðÿø‚ÿóÿ ÿÿÿÿ÷ÿÿÿÒÿ ÿÿÿÿýÿÿäÿÿòÿ ÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¶ÿÿÿîÿÿÿúÿÿÿýÿÿÿÿÿÿÿÿýÿÿÿøÿû‚ÿðÿø‚ÿóÿÿÿÿÿÿúÿÿÌÿÿÿÿýÿÿäÿÿõÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ›ÿÿÿúÿÿÿôÿÿÿúÿÿÿøÿû‚ÿðÿø‚ÿóÿÿÿÿÿÿýÿÿÿ¾ÿÿÿëÿ ÿÿÿÿûÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿöÿÿÿúÿÿÿøÿû‚ÿðÿø‚ÿöÿÿÿýÿÿÿÿÿÿÿ¾ÿ ÿÿÿñÿÿÿþÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿóÿÿÿýÿÿÿõÿû‚ÿðÿø‚ÿöÿÿÿúÿ ÿÿÿÿ¸ÿÿÿÿÿÿÿýÿ#ÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿðÿÿÿÿÿÿõÿû‚ÿðÿø‚ÿöÿÿÿ÷ÿ ÿÿÿµÿÿÿÿÿÿÿÿÿÿýÿÿþÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿíÿ ÿÿÿÿòÿû‚ÿðÿø‚ÿöÿÿñÿ¬ÿÿÿþÿÿÿÿÿÿÿñÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿäÿÿïÿû‚ÿðÿø‚ÿùÿÿÿ™ÿ ÿÿÿýÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿµÿû‚ÿðÿø‚ÿùÿÿÿ–ÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿµÿû‚ÿðÿø‚ÿùÿÿÿÿ”ÿ ÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ²ÿû‚ÿðÿø‚ÿüÿÿÿŠÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¬ÿû‚ÿðÿø’ÿ ÿÿÿÿýÿ ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ²ÿû‚ÿðÿø’ÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿû‚ÿðÿø•ÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿû‚ÿðÿø˜ÿÿÿ÷ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ©ÿû‚ÿðÿø›ÿ ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ—ÿû‚ÿðÿøžÿ ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ”ÿû‚ÿðÿø¡ÿ ÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ”ÿû‚ÿðÿø³ÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‘ÿû‚ÿðÿ‚‚‚‚‚‚‚‚‚‚–‚ÿðÿ‚‚‚‚‚‚‚‚‚‚–‚ÿðÿ‚‚‚‚‚‚‚‚‚‚–‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¥ÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿðÿ‚‚‚Èïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿðÿ‚‚‚Èïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿðÿû‚ÿ‚ÿ‚ÿÔÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿðÿû‚ÿ‚ÿ‚ÿÔÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿðÿû‚ÿ‚ÿ‚ÿÔÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ“ÿ¥‚ÿáÿû‚ÿ‚ÿ‚ÿÔÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ–ÿ¥ÿ¥‚ÿáÿû‚ÿ‚ÿ‚ÿÔÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ–ÿ¥ÿ¥ÿ¥‚ÿäÿû‚ÿ‚ÿ‚ÿÔÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ–ÿ¥ÿ¥ÿ¥‚ÿäÿû‚ÿ‚ÿ‚ÿÔÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ–ÿ¥ÿ¥ÿ¥‚ÿäÿû‚ÿ‚ÿ‚ÿÔÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ“ÿ¥ÿ¥‚ÿäÿû‚ÿ‚ÿ‚ÿÔÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ“ÿ¥ÿ¥‚ÿäÿû‚ÿÆÿ‚ÿ’ÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿœÿ¥ÿ¥ýÿ¥ÿ¥‚ÿäÿû‚ÿÉÿÿÿ‚ÿ•ÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿœÿ¥ÿ¥ýÿ¥ÿ¥‚ÿäÿû‚ÿÉÿ ÿÿÿ‚ÿ˜ÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿœÿ¥ÿ¥ýÿ¥ÿ¥‚ÿäÿû‚ÿÌÿ ÿÿÿÿ‚ÿ˜ÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿŸÿ¥ÿ¥ÿ¥ýÿ¥ÿ¥ÿ¥‚ÿçÿû‚ÿÌÿ ÿÿÿÿ‚ÿ˜ÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿŸÿ¥ÿ¥ÿ¥ýÿ¥ÿ¥ÿ¥‚ÿçÿû‚ÿÌÿ ÿÿÿÿ‚ÿ˜ÿûïÿû‚ÿðÿø‚ÿ–ÿæòÿæìÿÝ¿ÿìõÿïõÿòþÿþæÿéòÿé‚ÿûÿ¥ÿ¥ÿ¥ýÿ¥ÿ¥‚ÿäÿû‚ÿÌÿÿýÿÿ‚ÿ˜ÿûïÿû‚ÿðÿø‚ÿÿûõÿøõÿûòÿøòÿøìÿþ¹ÿøéÿûòÿûõÿûàÿûõÿøõÿøøÿø…ÿ¥ÿ¥ÿ¥‚ÿÛÿû‚ÿÌÿÿýÿÿÿîÿÿÿ‚ÿ¶ÿûïÿû‚ÿðÿø‚ÿÿûòÿøøÿûïÿûòÿøìÿþ¹ÿøéÿþïÿþïÿûãÿûïÿûøÿøòÿûˆÿ¥ÿ¥ÿ¥‚ÿÛÿû‚ÿÏÿÿÿýÿÿÿñÿ ÿÿÿ‚ÿ¶ÿûïÿû‚ÿðÿø‚ÿÿûòÿøøÿûïÿøõÿø¡ÿøéÿþòÿûïÿûãÿûïÿûøÿøòÿø‹ÿ¥ÿ¥‚ÿØÿû‚ÿÏÿÿÿýÿÿÿñÿ ÿÿÿÿ‚ÿ¹ÿûïÿû‚ÿðÿø‚ÿÿûòÿøøÿûïÿøõÿø¡ÿøéÿþòÿøïÿþãÿûïÿûøÿøòÿø‹ÿ¥ÿ¥‚ÿØÿû‚ÿÏÿÿÿýÿÿÿñÿ ÿÿÿÿ‚ÿ¹ÿûïÿû‚ÿðÿø‚ÿÿûòÿøøÿûïÿøõÿøïÿþ¶ÿøéÿþïÿøÑÿûïÿûøÿøòÿø‹ÿ¥ÿ¥‚ÿØÿû‚ÿÏÿÿÿýÿÿÿñÿ ÿÿÿÿ‚ÿ¹ÿûïÿû‚ÿðÿø‚ÿÿûòÿûõÿûòÿøòÿøïÿþ¶ÿøéÿþïÿõÔÿûïÿûøÿøòÿûˆÿ¥ÿ¥‚ÿØÿû‚ÿÏÿÿÿýÿÿÿñÿÿýÿÿ‚ÿ¹ÿûïÿû‚ÿðÿø»ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ëÿ"¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥îÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥Ôÿûõÿøõÿûøÿõïÿã¶ÿøéÿþìÿõ×ÿûòÿûõÿøõÿø‚ÿøÿ¥ÿ¥ÿ¥‚ÿêÿû‚ÿÏÿÿÿýÿÿÿôÿÿÿýÿÿ‚ÿ¹ÿûïÿû‚ÿðÿø»ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ëÿ"¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥îÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥Ôÿìïÿûøÿõïÿøòÿû¶ÿøéÿþéÿòÝÿéòÿé‚ÿòÿ¥ÿ¥ÿ¥‚ÿêÿû‚ÿÑÿ¥þ ÿÿÿÿ¥ÿ¥þÿôÿ ÿÿÿÿ¥þÿ‚ÿ¹ÿûïÿû‚ÿðÿø‚ÿÿûàÿûïÿøõÿøïÿþ¶ÿøéÿþãÿõàÿûàÿø‚ÿãÿ¥ÿ¥ÿ¥‚ÿêÿû‚ÿÑÿ¥þ ÿÿÿÿ¥ÿ¥þÿÿùÿ¥þÿÿÿÿ¥þÿÿ‚ÿ¼ÿûïÿû‚ÿðÿø‚ÿÿûàÿûïÿøõÿøïÿþãÿïæÿøéÿþàÿõãÿûàÿø‚ÿãÿ¥ÿ¥ÿ¥‚ÿêÿû‚ÿÑÿ¥þÿüÿ¥ÿ¥þÿÿùÿ¥þÿÿÿ¥ÿ¥þÿÿ‚ÿ¼ÿûïÿû‚ÿðÿø‚ÿÿûàÿûìÿøøÿø¡ÿøéÿþõÿþìÿøãÿûàÿø‚ÿàÿ¥ÿ¥‚ÿêÿû‚ÿÑÿ¥þÿùÿ¥þÿÿùÿ¥þÿÿÿ¥ÿ¥þÿÿ‚ÿ¼ÿûïÿû‚ÿðÿø‚ÿÿûàÿûìÿøøÿøæÿþ¼ÿûéÿþõÿûìÿûãÿûàÿø‚ÿàÿ¥ÿ¥‚ÿêÿû‚ÿÒÿÿÿùÿ¥þÿÿùÿ¥þÿüÿ¥þÿÿ‚ÿ¼ÿûïÿû‚ÿðÿø‚ÿÿûàÿûïÿøõÿøéÿþ¹ÿûéÿþòÿþìÿûãÿûàÿø‚ÿàÿ¥ÿ¥ÿ¥‚ÿíÿû‚ÿÒÿÿÿùÿ¥ÿ¥þÿüÿ¥þÿÿüÿ¥ÿ¥þÿ‚ÿ¼ÿûïÿû‚ÿðÿø‚ÿÿûàÿûïÿøõÿøìÿû¹ÿøïÿþïÿûòÿøãÿûàÿø‚ÿõÿ¥ÿ¥ÿ¥ôÿ¥ÿ¥ÿ¥‚ÿíÿû‚ÿÒÿÿÿùÿ¥ÿ¥þÿüÿ¥þÿÿüÿ¥ÿ¥þÿ‚ÿ¼ÿûïÿû‚ÿðÿø‚ÿ“ÿòæÿãïÿà³ÿéìÿøøÿûàÿõæÿò‚ÿøÿ¥ÿ¥ñÿ¥ÿ¥ÿ¥‚ÿíÿû‚ÿÒÿÿÿùÿ¥ÿ¥þÿÿÿÿ¥þÿùÿ¥ÿ¥þÿ‚ÿ¼ÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿÂÿõæÿþøÿø‚ÿžÿ¥ÿ¥ñÿ¥ÿ¥ÿ¥‚ÿíÿû‚ÿÒÿÿÿùÿ¥ÿ¥þÿÿÿÿÿùÿ¥ÿ¥þÿ‚ÿ¼ÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¢ÿ¥ÿ¥ñÿ¥ÿ¥ÿ¥‚ÿíÿû‚ÿÒÿÿÿöÿ¥þÿÿÿÿÿùÿ¥ÿ¥þÿ‚ÿ¼ÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¢ÿ¥ÿ¥îÿ¥ÿ¥‚ÿíÿû‚ÿÒÿÿÿöÿ¥ÿ¥þ ÿÿÿÿöÿ¥þÿÿ‚ÿ¿ÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¢ÿ¥ÿ¥‚ÿÕÿû‚ÿÔÿ¥þÿÿñÿ ÿÿÿÿöÿ¥þÿÿ‚ÿ¿ÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¢ÿ¥ÿ¥‚ÿÕÿû‚ÿÔÿ¥þÿÿñÿ ÿÿÿñÿÿÿ‚ÿ¿ÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¢ÿ¥ÿ¥ìÿÿ‚ÿïÿû‚ÿÔÿ¥þÿÿîÿÿîÿÿÿ‚ÿ¿ÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÀÿ¥ÿ¥ÿ¥îÿ¥ÿ¥ÿ¥ïÿÿÿ‚ÿïÿû‚ÿÔÿ¥þÿÐÿÿ‚ÿ¿ÿûïÿû‚ÿðÿø‚ÿ“ÿæõÿÚ¿ÿõìÿõïÿøøÿõæÿéòÿæ‚ÿûÿ ¥ÿ¥ÿ¥ÿ¥ñÿ¥ÿ¥ÿ¥òÿ ÿÿÿÿ‚ÿòÿû‚ÿÔÿ¥þÿÐÿÿ‚ÿÁÿ¥úïÿû‚ÿðÿø‚ÿÿûõÿøûÿþéÿø¹ÿõìÿûòÿøìÿûãÿûõÿøõÿûòÿû‚ÿ ¥ÿ¥ÿ¥ÿ¥ÿ¥ñÿ¥ÿ¥ÿ¥òÿ ÿÿÿÿ‚ÿòÿû‚ÿÕÿÿÿÐÿÿÿ‚ÿÄÿ¥úïÿû‚ÿðÿø‚ÿÿûòÿøþÿþéÿø¹ÿõéÿþòÿûéÿûãÿûòÿøøÿûïÿû…ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ñÿ¥ÿ¥òÿ ÿÿÿÿœÿ¥Úÿû‚ÿÕÿÿÿÐÿÿÿ‚ÿÄÿ¥úïÿû‚ÿðÿø‚ÿÿûòÿøþÿþìÿø¶ÿþþÿøìÿþõÿûãÿþãÿûïÿûøÿûïÿû…ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥Ýÿ ÿÿÿÿ£ÿÿÿÙÿû‚ÿÕÿÿÿÒÿ¥þÿÿ‚ÿÇÿ¥ÿ¥úïÿû‚ÿðÿø‚ÿÿûòÿøéÿø³ÿþûÿøïÿþõÿûãÿþãÿûïÿûøÿûïÿû…ÿ¥ÿ¥ÿ¥ýÿ¥ÿ¥ÿ¥àÿ ÿÿÿÿ¨ÿ¥ÿ¥þÿÿÙÿû‚ÿÕÿÿÿÒÿ¥þÿÿ‚ÿÇÿ¥ÿ¥úïÿû‚ÿðÿø‚ÿÿûòÿøéÿû°ÿþøÿøòÿþøÿøÂÿûïÿûøÿûïÿû‚ÿÒÿÿÿýÿÿÿ«ÿ¥þÿÿÿÙÿû‚ÿÕÿÿÿÒÿ¥þÿÿ‚ÿÇÿ¥ÿ¥úïÿû‚ÿðÿø¼ÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÓÿûòÿûéÿø°ÿþøÿõõÿþøÿøÂÿûòÿûõÿûòÿø‚ÿÕÿ ÿÿÿýÿÿÿ«ÿ¥þÿÿÿÙÿû‚ÿ×ÿ¥þÿÏÿ¥þÿÿ‚ÿÊÿ¥ÿ¥ÿ¥úïÿû‚ÿðÿø¼ÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÓÿûõÿøìÿø­ÿþõÿøõÿþøÿøÂÿûõÿøõÿûõÿø‚ÿÒÿÿÿúÿÿÿ«ÿ¥þ ÿÿÿÿÜÿû‚ÿ×ÿ¥þÿÏÿ¥þÿÿ‚ÿÊÿ¥ÿ¥ÿ¥úïÿû‚ÿðÿø¼ÿ~ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÓÿïæÿõ­ÿþòÿøøÿþøÿøÂÿïìÿï‚ÿÉÿÿÿùÿ¥þÿÿ®ÿ¥þ ÿÿÿÿÜÿû‚ÿÕÿÿÏÿ¥ÿ¥þÿ‚ÿÊÿ¥ÿ¥ÿ¥úïÿû‚ÿðÿø‚ÿÿûÚÿøªÿþïÿøûÿþøÿøÂÿûàÿû‚ÿÑÿ¥ÿ¥ÿ¥õÿÿöÿ¥þÿÿ®ÿ¥þ ÿÿÿÿÜÿû‚ÿÕÿÿÏÿ¥ÿ¥þÿÿ‚ÿÍÿ¥ÿ¥ÿ¥úïÿû‚ÿðÿø‚ÿÿûÝÿøÔÿïæÿþìÿøþÿþøÿøÂÿûàÿû‚ÿÑÿ¥ÿ¥ÿ¥õÿÿöÿ¥þÿÿ±ÿ¥ÿ¥þ ÿÿÿÿÜÿû‚ÿÕÿÿÏÿ¥ÿ¥þÿÿ‚ÿÐÿ¥ÿ¥ÿ¥þÿûïÿû‚ÿðÿø‚ÿÿûÝÿû¤ÿþìÿøþÿþõÿûÂÿûàÿû‚ÿÑÿ¥ÿ¥ÿ¥õÿÿôÿÿÿ±ÿ¥ÿ¥þ ÿÿÿÿÜÿû‚ÿÕÿÿÏÿ¥ÿ¥þÿÿ‚ÿËÿÿÿûïÿû‚ÿðÿø‚ÿÿûàÿø¤ÿþéÿõõÿøÅÿûàÿû‚ÿïÿ¥ÿ¥ÿ¥ôÿ ¥ÿ¥ÿ¥ÿ¥ÿ¥õÿÿÿóÿ¥þÿ±ÿ¥ÿ¥þ ÿÿÿÿÜÿû‚ÿØÿÿÿÌÿ¥þÿÿ‚ÿËÿÿÿûïÿû‚ÿðÿø‚ÿÿûãÿøéÿþ¼ÿþæÿøòÿøéÿþãÿûàÿû‚ÿïÿ¥ÿ¥ÿ¥ôÿ ¥ÿ¥ÿ¥ÿ¥ÿ¥õÿÿÿóÿ¥þÿ±ÿ¥ÿ¥þÿýÿÿÿßÿû‚ÿØÿÿÿÌÿ¥þÿÿ‚ÿÎÿÿÿÿûïÿû‚ÿðÿø‚ÿÿûæÿøæÿþ¼ÿûæÿûïÿøòÿûàÿûàÿû‚ÿïÿ¥ÿ¥ÿ¥ñÿ ¥ÿ¥ÿ¥ÿ¥õÿÿÿñÿÿÿ´ÿ¥ÿ¥þÿýÿÿÿßÿû‚ÿØÿÿÿÌÿ¥þÿÿ‚ÿÑÿ ÿÿÿÿûïÿû‚ÿðÿø‚ÿ–ÿììÿÚÂÿïéÿþéÿïãÿììÿì‚ÿøÿ¥ÿ¥ÿ¥ñÿ ¥ÿ¥ÿ¥ÿ¥õÿÿîÿÿÿ´ÿ¥þÿÿúÿÿßÿû‚ÿÚÿ¥þÿÿÇÿÿ‚ÿòÿÿÿÿÿÿôÿÿÿúÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÆÿ¥ÿ¥ÿ¥ñÿ¥ÿ¥ÿ¥òÿÿîÿÿÿ²ÿÿÿúÿÿÿâÿû‚ÿÚÿ¥þÿÄÿÿÿ‚ÿøÿÿÿÿÿÿÿÿÿýÿ ÿÿÿúÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÆÿ¥ÿ¥ÿ¥Ýÿÿÿîÿÿÿ²ÿÿÿúÿÿÿâÿû‚ÿÚÿ¥þÿÄÿÿÿ‚ÿøÿÿÿýÿÿÿÿÿÿÿÿÿ÷ÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÆÿ¥ÿ¥ÿ¥àÿ ÿÿÿîÿÿÿ²ÿÿÿúÿÿÿâÿû‚ÿÚÿ¥þÿÄÿÿÿ‚ÿûÿÿÿüÿ¥øÿ ÿÿÿÿôÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÆÿ¥ÿ¥ÿ¥ãÿ ÿÿÿÿîÿÿÿ²ÿÿÿ÷ÿÿâÿû‚ÿÚÿ¥þÿÁÿÿ‚ÿûÿÿÿÿÿ¥ÿ¥ÿ¥÷ÿ¥ÿ¥ÿ¥òÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÆÿ¥ÿ¥ÿ¥ãÿ ÿÿÿëÿÿÿ²ÿÿÿ÷ÿÿâÿû‚ÿÛÿÿÿÁÿÿ‚ÿþÿÿÿüÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥òÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÆÿ¥ÿ¥ÿ¥ãÿÿåÿÿÿ²ÿÿÿüÿ¥ÿ¥þÿÿåÿû‚ÿÝÿ¥þÿÿÃÿ¥þÿÿŠÿ¥ÿ¥þÿÿÿùÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ïÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÆÿ¥ÿ¥ãÿÿÿåÿÿÿ²ÿÿöÿ¥þÿÿåÿû‚ÿÝÿ¥þÿÿÆÿ¥ÿ¥þÿÿŠÿ¥ÿ¥þÿÿóÿ ¥ÿ¥ÿ¥ÿ¥éÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ©ÿ ÿÿÿÿåÿÿÿ·ÿ¥ÿ¥þÿöÿ¥þÿÿåÿû‚ÿÝÿ¥þÿÀÿ¥ÿ¥þÿÿÿ¥ÿ¥þÿÿÍÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ©ÿ ÿÿÿáÿ¥þÿ·ÿ¥ÿ¥þÿöÿ¥þÿÿåÿû‚ÿÞÿÿÿÀÿ¥ÿ¥þÿÿ÷ÿÿ¢ÿ¥ÿ¥ÿ¥þÿÿÍÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ©ÿ ÿÿÿáÿ¥þÿ·ÿ¥ÿ¥þÿöÿ¥þÿÿåÿû‚ÿÞÿÿÿ½ÿ¥þÿÿúÿ ÿÿÿ¥ÿ¥ÿ¥ÿ¥þÿÿÍÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿµÿÿÿÿÿÿÛÿ¥þÿ·ÿ¥ÿ¥þÿöÿ¥ÿ¥þÿåÿû‚ÿÞÿÿÿ½ÿ¥ÿ¥þÿÿÿÿÿÿÿÿ«ÿ¥ÿ¥ÿ¥þÿÿÊÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ»ÿÿÿÿÿÿÿÿÛÿ¥þÿÿêÿ¥ÿ¥Ùÿ¥ÿ¥ÿ¥þÿöÿ¥ÿ¥þÿÿèÿû‚ÿÞÿÿÿºÿ¥þÿÿÿÿÿÿÿÿ®ÿ ¥ÿ¥ÿ¥ÿ¥þÿÿÊÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¾ÿÿÿÿÿÿÿÿÿÛÿ¥þÿÿíÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥âÿ¥ÿ¥ÿ¥þÿöÿ¥ÿ¥þÿÿèÿûƒÿ ÿÿÿèÿÿÿ·ÿ¥ÿ¥þÿ÷ÿÿÿ±ÿ¥ÿ¥ÿ¥þÿÿÇÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¾ÿÿÿÿÿÿÿÿÿÛÿ¥þÿÿíÿ¥ÿ¥ÿ¥ýÿ¥ÿ¥âÿ¥ÿ¥þÿÿöÿ¥ÿ¥þÿÿÿëÿûƒÿ ÿÿÿèÿÿ ÿÿÿ´ÿ ¥ÿ¥ÿ¥ÿ¥þÿÿÇÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÉÿ¥ÿ¥ÿ¥þÿÿÿúÿÿÿÖÿÿÿíÿ¥ÿ¥ÿ¥ýÿ¥ÿ¥ÿ¥åÿ¥ÿ¥þÿÿóÿ¥ÿ¥þÿÿëÿû†ÿÿÿÿÿÿîÿÿÿÿÿÿ·ÿ¥ÿ¥ÿ¥þÿÿÄÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÉÿ¥ÿ¥ûÿÿÄÿÿÿðÿ¥ÿ¥ÿ¥úÿ¥ÿ¥ÿ¥åÿ¥ÿ¥þÿÿóÿ¥ÿ¥ÿ¥þÿëÿû†ÿÿÿÿÿÿîÿÿÿÿÿÿ·ÿ¥ÿ¥ÿ¥þÿÿÄÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÉÿ¥ÿ¥ûÿÿÄÿÿÿðÿ¥ÿ¥ÿ¥÷ÿ¥ÿ¥åÿ¥ÿ¥þÿÿëÿÿëÿûˆÿ¥þÿÿýÿÿÿóÿ¥þÿÿŸÿ¥ÿ¥þÿÿµÿÿÿÁÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÉÿ¥ÿ¥ûÿÿÁÿÿðÿ¥ÿ¥ÿ¥÷ÿ¥ÿ¥èÿ¥ÿ¥ÿ¥þÿÿëÿÿëÿû‰ÿÿÿúÿÿÿóÿ¥þÿ™ÿ¥þÿÿµÿÿÿÁÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÉÿ¥ÿ¥þÿÿÿÁÿÿðÿ¥ÿ¥ÿ¥÷ÿ¥ÿ¥âÿ¥þÿÿëÿÿÿîÿû‰ÿÿÿúÿÿÿôÿÿÿ™ÿ¥þÿÿÿ»ÿÿÿ¾ÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÉÿ¥ÿ¥þÿÿÿÁÿÿðÿ¥ÿ¥ÿ¥÷ÿ¥ÿ¥ÿ¥ãÿÿÿëÿÿÿîÿû‹ÿ¥þÿÿ÷ÿÿÿùÿ¥þÿÿ–ÿ¥þÿÿ¾ÿ ÿÿÿ¾ÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÉÿ¥ÿ¥þÿÿÿÁÿÿðÿ¥ÿ¥ôÿ¥ÿ¥ÿ¥ãÿÿèÿÿÿîÿû‹ÿ¥þÿôÿÿÿúÿÿÿ“ÿ¥ÿ¥þÿÿÿÿ¥ÿ¥ÿ¥æÿ"ÿÿÿÿÿÿÿÿÿÿÿ»ÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÉÿ¥ÿ¥þÿÿ¾ÿÿóÿ¥ÿ¥ÿ¥ñÿ¥ÿ¥ãÿÿèÿÿÿîÿûŒÿÿÿñÿÿÿÿÿÿÿŽÿÿÿÿÿÿÿÿîÿ"ÿÿÿÿÿÿÿÿÿÿÿ¸ÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÉÿ¥ÿ¥þÿÿ¾ÿÿÿÿ¥÷ÿ¥ÿ¥ÿ¥ñÿ¥ÿ¥ãÿÿèÿÿÿîÿûŒÿÿÿñÿÿÿÿÿÿˆÿÿÿÿÿÿÿÿÿ÷ÿÿÿÿÿÿÿ¥ÿ¥þ ÿÿÿÿµÿûïÿû¿ÿþ¶ÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÌÿ¥ÿ¥ÿ¥þÿÿ¾ÿÿÿÿ¥ßÿ¥ÿ¥æÿÿÿçÿ¥þÿîÿûŒÿÿíÿ¥þ ÿÿÿÿ‚ÿ)ÿÿÿÿÿÿÿÿÿÿÿÿÿÿ¥žÿûïÿû¿ÿû¹ÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÌÿ¥ÿ¥ÿ¥þÿÿ¾ÿÿÿâÿÿðÿ¥ÿ¥ÿ¥ûÿÿÿçÿ¥þÿÿñÿûŒÿÿêÿ¥ÿ¥ÿ¥‚ÿðÿÿÿÿÿÿÿÿÿÿ¥›ÿûïÿû¿ÿòÂÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÄÿÿÿ¾ÿÿÿåÿ ÿÿÿÿöÿ¥ÿ¥ÿ¥ûÿÿÿåÿÿÿñÿûÿÿÿ‚ÿÄÿ ¥ÿ¥ÿ¥ÿ¥˜ÿûïÿû¿ÿþøÿõËÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿÿÿ»ÿ ÿÿÿÿ¥éÿ ÿÿÿÿöÿ¥ÿ¥ÿ¥ûÿÿÿåÿÿÿñÿûÿÿÿ‚ÿÄÿ¥ÿ¥’ÿûïÿû­ÿøÎÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿÿÿ»ÿ ÿÿÿÿ¥éÿÿýÿÿùÿ¥ÿ¥ÿ¥øÿÿÿåÿÿÿñÿûÿÿ‚ÿÁÿ¥ÿûïÿû¤ÿø×ÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿÿÿ»ÿ ÿÿÿÿ¥ìÿÿÿýÿÿÿüÿ¥ÿ¥ÿ¥øÿÿÿåÿÿÿñÿû’ÿÿÿ‚ÿ‚ÿÌÿûïÿû¤ÿïàÿø‚ÿ‚ÿ‚ÿ‚ÿ•ÿ¥ÿ¥¹ÿÿÿ¸ÿÿÿÿ¥ÿ¥ÿ¥ÿ¥õÿÿÿýÿÿÿüÿ¥ÿ¥ÿ¥øÿÿÿåÿÿÿñÿû”ÿ¥þÿÿ‚ÿ‚ÿÌÿûïÿû­ÿïøÿûæÿø‚ÿ‚ÿ‚ÿ‚ÿ•ÿ¥ÿ¥ÿ¥¼ÿÿÿ¸ÿÿÿÿ¥ÿ¥ÿ¥òÿÿÿýÿÿÿÿÿ¥ÿ¥ÿ¥õÿÿÿåÿÿÿñÿû•ÿÿÿ‚ÿ‚ÿÉÿûïÿû¿ÿþõÿïòÿûéÿø‚ÿ‚ÿ‚ÿ‚ÿ•ÿ¥ÿ¥ÿ¥îÿ¥ÿ¥ÿ¥×ÿÿµÿÿÿÿÿ¥ÿ¥òÿÿÿýÿÿÿÿÿ¥ÿ¥ÿ¥õÿÿÿåÿÿÿñÿû•ÿÿÿ‚ÿ‚ÿÉÿûïÿû¿ÿéãÿûïÿø‚ÿ‚ÿ‚ÿ‚ÿÚÿ¥ÿ¥ÿ¥Äÿ¥ÿ¥ÿ¥ñÿ ¥ÿ¥ÿ¥ÿ¥ÿ¥âÿ¥ÿ¥þÿÿµÿÿÿëÿÿÿýÿÿÿÿÿ¥ÿ¥òÿÿÿäÿ¥þÿñÿû³ÿÿÿîÿ ÿÿÿ‚ÿ‚ÿÉÿûïÿû¿ÿïÝÿûïÿø‚ÿ‚ÿ‚ÿ‚ÿÝÿ ¥ÿ¥ÿ¥ÿ¥Óÿ¥ñÿ¥ÿ¥ÿ¥÷ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥âÿ¥ÿ¥þÿÿµÿÿÿëÿÿÿúÿÿÿÿ¥ïÿÿÿäÿ¥þÿÿôÿû¶ÿ ÿÿÿÿóÿ¥þÿÿ‚ÿ‚ÿÆÿûïÿû¿ÿø×ÿøïÿø‚ÿ‚ÿ‚ÿ‚ÿÝÿ ¥ÿ¥ÿ¥ÿ¥ÿ¥Öÿ¥ÿ¥ÿ¥÷ÿ¥ÿ¥ÿ¥÷ÿ¥ÿ¥ÿ¥ýÿ¥ÿ¥ÿ¥åÿ¥ÿ¥þÿÿµÿÿÿëÿÿ÷ÿÿëÿÿÿâÿÿÿôÿû¹ÿÿÿÿÿÿÿÿýÿ ÿÿÿ‚ÿ‚ÿÃÿûïÿû¿ÿûÔÿøïÿø‚ÿ‚ÿ‚ÿ‚ÿÝÿ ¥ÿ¥ÿ¥ÿ¥ÿ¥Öÿ¥ÿ¥ÿ¥ôÿ¥ÿ¥ôÿ¥úÿ¥ÿ¥ÿ¥åÿ¥ÿ¥þÿÿµÿÿÿëÿÿ÷ÿÿÿîÿÿßÿÿÿôÿû¼ÿ ÿÿÿúÿÿÿÿÿÿÿ‚ÿ‚ÿÀÿûïÿû¿ÿþÎÿþìÿø‚ÿ‚ÿ‚ÿ‚ÿÝÿ ¥ÿ¥ÿ¥ÿ¥ÿ¥Öÿ¥ÿ¥ÿ¥ôÿ¥ÿ¥ëÿ¥ÿ¥ÿ¥åÿ¥ÿ¥þÿ²ÿÿÿîÿÿÿ÷ÿÿÿîÿÿßÿÿÿôÿû¾ÿ¥þÿÿôÿ ÿÿÿÿ‚ÿ‚ÿ½ÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿàÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥Ùÿ¥ÿ¥ÿ¥ñÿ¥ÿ¥ÿ¥þÿÿóÿ¥ÿ¥ÿ¥èÿ¥ÿ¥þÿ²ÿÿÿîÿÿÿ÷ÿÿÿîÿÿßÿÿÿôÿû¿ÿ ÿÿÿðÿ¥ÿ¥ÿ¥ú›ÿû›ÿû›ÿûïÿû¿ÿþàÿþÚÿø‚ÿ‚ÿ‚ÿ‚ÿàÿ¥ÿ¥ÿ¥Ðÿ¥ÿ¥îÿ¥ÿ¥ÿ¥þÿÿÿöÿ¥ÿ¥åÿ¥ÿ¥þÿ²ÿÿÿîÿÿÿ÷ÿÿÿîÿÿßÿÿÿôÿûÂÿ ÿÿÿåÿû›ÿû›ÿû›ÿûïÿû¿ÿþÝÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿªÿ¥ÿ¥ÿ¥ëÿ¥þÿÿÿÿÿÿÛÿ¥ÿ¥þÿ²ÿÿÿîÿÿÿ÷ÿÿÿñÿÿÿÜÿÿôÿûÄÿ¥þÿÿâÿû›ÿû›ÿû›ÿûïÿû¿ÿþàÿûÝÿø‚ÿ‚ÿ‚ÿ‚ÿªÿ¥ÿ¥ÿ¥ëÿ¥þÿÿÿÿÿÿÿáÿ¥ÿ¥þÿÿ²ÿÿÿîÿÿÿ÷ÿÿÿñÿÿÿÞÿ¥þÿôÿûÇÿ¥þÿÿßÿû›ÿû›ÿû›ÿûïÿûÈÿÎÝÿø‚ÿ‚ÿ‚ÿ‚ÿªÿ¥ÿ¥æÿÿÿýÿ ÿÿÿáÿ¥ÿ¥þÿÿ¯ÿÿîÿÿÿ÷ÿÿÿñÿÿÿÞÿ¥þÿôÿûËÿ ÿÿÿÜÿû›ÿû›ÿû›ÿûïÿûÅÿÔÚÿø‚ÿ‚ÿ‚ÿ‚ÿ­ÿ¥ÿ¥ÿ¥øÿ ÿÿÿúÿÿÿúÿÿÿáÿ¥ÿ¥þÿÿ¯ÿÿîÿÿÿôÿÿñÿÿÿÞÿ¥þÿÿ÷ÿûÑÿ ÿÿÿÿÙÿû›ÿû›ÿû›ÿûïÿû¿ÿþ¶ÿø‚ÿ‚ÿ‚ÿ‚ÿ­ÿ¥ÿ¥ÿ¥øÿÿÿÿÿÿÿÿôÿ ÿÿÿÿöÿ¥ôÿ¥þÿ¬ÿÿÿôÿÿÿñÿÿÿôÿÿÿÞÿ¥þÿÿ÷ÿûÝÿÿÿÿÿÿÿÿÖÿû›ÿû›ÿû›ÿûïÿû¿ÿþ¶ÿø‚ÿ‚ÿ‚ÿ‚ÿÑÿ¥ÿ¥âÿ¥ÿ¥õÿÿÿÿÿÿÿÿôÿÿÿÿÿÿÿÿÿÿ¥õÿÿÿ¬ÿÿÿôÿÿÿñÿÿÿôÿÿÿÞÿ¥þÿÿ÷ÿûþÿ1ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÐÿû›ÿû›ÿû›ÿûïÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿãÿ¥ÿ¥ôÿ¥ÿ¥Ñÿÿÿÿÿÿÿîÿÿÿÿÿÿÿÿÿÿ¥øÿÿÿ¬ÿÿÿôÿÿÿñÿÿÿôÿÿÿÞÿ¥þÿÿ÷ÿù,ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÊÿû›ÿû›ÿû›ÿûïÿû˜ÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿãÿ¥ÿ¥ÿ¥÷ÿ¥ÿ¥ÿ¥Ôÿÿÿÿÿÿåÿÿÿÿÿÿÿÿ¥øÿÿÿ¬ÿÿÿôÿÿëÿÿôÿÿÿÞÿ¥þÿÿ÷ÿ‚‚‚Èïÿû˜ÿþÝÿø¤ÿûÚÿþ‚ÿ‚ÿ‚ÿñÿ¥ÿ¥ÿ¥÷ÿ¥ÿ¥ÿ¥×ÿÿÿÖÿÿÿÿÿÿÿýÿÿÿ©ÿÿÿ÷ÿÿÿëÿÿÿ÷ÿÿÿÛÿ¥þÿ÷ÿ‚‚‚ÈïÿûÑÿûõÿ×Ýÿø¹ÿþûÿï×ÿþ‚ÿ‚ÿ‚ÿôÿ¥ÿ¥ôÿ¥ÿ¥ÿ¥×ÿÿÿÍÿÿÿÿÿÿÿÿ©ÿÿÿ÷ÿÿÿëÿÿÿ÷ÿÿÿÛÿ¥þÿ‚ÿ‚ÿ‚ÿ¬ÿûÑÿûõÿ×Ýÿø¼ÿûõÿõÔÿþ‚ÿ‚ÿ‚ÿ÷ÿ¥ÿ¥ñÿ¥ÿ¥×ÿÿÿÍÿÿÿÿÿÿÿÿ©ÿÿÿ÷ÿÿÿëÿÿÿ÷ÿÿØÿ¥þÿ‚ÿ‚ÿ‚ÿ¬ÿûÑÿûòÿÚÝÿø¿ÿûïÿøÑÿþ‚ÿ‚ÿ‚ÿýÿ¥ÿ¥ÿ¥ñÿ¥ÿ¥ÿ¥ÝÿÿÿÆÿ¥ÿ¥þ ÿÿÿÿ©ÿÿÿ÷ÿÿåÿÿÿýÿÿÿØÿ¥þÿ‚ÿ‚ÿ‚ÿ¬ÿû¼ÿþàÿþÝÿøÂÿûìÿøÎÿþ‚ÿ‚ÿ‚ÿÿ¥ÿ¥ÿ¥ñÿ¥ÿ¥ÿ¥îÿ¥ÿ¥ÿ¥øÿÿÿÆÿ¥ÿ¥þÿÿÿ¦ÿÿÿúÿÿÿåÿÿÿýÿÿÿØÿ¥þÿ‚ÿ‚ÿ‚ÿ¬ÿû˜ÿþÝÿøÅÿûéÿøÎÿû‚ÿ‚ÿ„ÿ¥ÿ¥ÿ¥ñÿ¥ÿ¥ÿ¥îÿ¥ÿ¥ÿ¥øÿÿÿÃÿ¥þÿÿÿ£ÿÿÿýÿÿÿåÿÿÿýÿÿÿÖÿÿ‚ÿ‚ÿ‚ÿ¬ÿû‚ÿðÿøÅÿûéÿøËÿþ‚ÿ‚ÿ„ÿ¥ÿ¥ÿ¥ñÿ¥ÿ¥ÿ¥ñÿ¥ÿ¥ÿ¥õÿÿÿ¾ÿÿ ÿÿÿýÿÿÿåÿÿÿýÿÿÓÿÿúÿò›ÿûžÿþžÿþøÿþ­ÿûòÿþõÿû‚ÿðÿøÈÿûæÿøËÿû‚ÿ‚ÿ‡ÿ¥ÿ¥ÿ¥ñÿ¥ÿ¥ÿ¥ñÿ¥ÿ¥ÿ¥õÿÿ‚ÿÔÿÿÿýÿÿÿåÿÿÿÿÿÿÓÿÿýÿþøÿû›ÿû¡ÿûžÿþõÿþ³ÿþþÿþòÿþøÿø§ÿòÚÿøÈÿûæÿøûÿòàÿø‚ÿ‚ÿŠÿ¥ÿ¥ÿ¥ñÿ¥ÿ¥ÿ¥ñÿ¥ÿ¥ÿ¥øÿÿÿ‚ÿÑÿÿÿÿÿÿâÿ ÿÿÿÿÓÿÿÿñÿþ›ÿû¤ÿûžÿûõÿþ­ÿþõÿûøÿø¼ÿûõÿïÚÿøÈÿûæÿøþÿéæÿø‚ÿ‚ÿŠÿ¥ÿ¥ÿ¥þÿÿÿäÿ¥ÿ¥õÿÿÿ‚ÿÑÿ ÿÿÿÿßÿ ÿÿÿÐÿÿÿñÿþ¡ÿþþÿû§ÿû˜ÿþøÿþªÿþõÿþòÿû¿ÿûòÿûõÿþÝÿøËÿøæÿõõÿõãÿû‚ÿ‚ÿ‚ÿ ÿÿÿÿçÿ¥ÿ¥õÿÿÿ‚ÿÎÿ ÿÿÿßÿ ÿÿÿÐÿÿÿôÿû¤ÿþûÿû§ÿï¡ÿø§ÿþõÿþòÿû¿ÿþòÿøõÿþÝÿøËÿøæÿøïÿõæÿø‚ÿ‚ÿˆÿÿÿÿÿÿçÿ¥ÿ¥õÿÿÿ‚ÿËÿÿÙÿÿÍÿÿÿôÿû›ÿû§ÿûûÿû¡ÿø§ÿþõÿþòÿû¿ÿþõÿøòÿþÝÿøËÿûãÿøìÿøæÿø‚ÿ‚ÿˆÿÿÿÿÿÿêÿ¥ÿ¥ÿ¥õÿÿÿ‚ÿ‚ÿäÿÿÿˆÿû§ÿþõÿû¤ÿþþÿûªÿþõÿþòÿû¿ÿþõÿøòÿþÝÿøËÿûãÿøìÿøæÿø‚ÿ‚ÿˆÿÿýÿÿÿêÿ¥ÿ¥ÿ¥õÿÿ‚ÿ‚ÿàÿ¥þÿ—ÿéªÿþòÿþ§ÿþøÿû­ÿþõÿþòÿû¿ÿûûÿøïÿþÝÿøËÿûãÿøéÿøéÿø‚ÿ‚ÿˆÿÿúÿÿÿíÿ¥ÿ¥ÿ¥øÿÿÿ‚ÿ‚ÿàÿ¥þÿˆÿû§ÿþòÿþªÿûõÿþ­ÿþõÿûøÿø¹ÿõòÿûÚÿøËÿûãÿøéÿøéÿø‚ÿ‚ÿˆÿÿúÿÿÿÿÿ¥ÿ¥ÿ¥ôÿ¥õÿÿÿ‚ÿ‚ÿàÿ¥þÿýÿþõÿþžÿû§ÿûõÿþªÿûõÿþ­ÿþõÿûøÿø¶ÿûõÿòÝÿøËÿûãÿøéÿøéÿø‚ÿ‚ÿ‹ÿÿÿúÿÿÿÿÿÿÿ¥æÿÿÿ‚ÿ‚ÿàÿ¥þÿÿìžÿû¤ÿþøÿþ¤ÿþõÿþ­ÿþòÿþøÿø‚ÿðÿøËÿûãÿøéÿøéÿø‚ÿ‚ÿÿ¥ÿ¥þÿÿ÷ÿÿÿÿÿÿ¥ÿ¥éÿÿÿ‚ÿ‚ÿàÿ¥þÿ‚ÿ¡ÿû˜ÿûÿûþÿû˜ÿþÝÿøËÿûãÿøéÿûæÿø‚ÿ‚ÿÿ¥ÿ¥þÿÿñÿ ÿÿÿÿ¥éÿÿ‚ÿ‚ÿÝÿ¥þÿ‚ÿ‚ÿ‚ÿ¯ÿû˜ÿþÝÿøËÿøæÿøéÿûæÿø‚ÿ‚ÿÿ¥ÿ¥þÿÿñÿ ÿÿÿÿ¥éÿÿ‚ÿ‚ÿÝÿ¥þÿÿ‚ÿ‚ÿ‚ÿ²ÿû¶ÿàÝÿøËÿøæÿøéÿûæÿû‚ÿ‚ÿÿ¥ÿ¥þÿîÿ ÿÿÿÿ¥éÿÿ‚ÿ‚ÿÝÿ¥þÿÿ‚ÿ‚ÿ‚ÿ²ÿû¼ÿÚÝÿøÈÿûæÿøìÿûãÿû‚ÿ‚ÿÿ¥ÿ¥ÿ¥þÿîÿ ÿÿÿÿ¥ìÿÿÿ‚ÿ‚ÿÝÿ¥þÿÿ‚ÿ‚ÿ‚ÿ²ÿû¿ÿ×ÝÿøÈÿûæÿøïÿûãÿø‚ÿ‚ÿÿ¥ÿ¥þÿÿëÿÿÿÿÿ¥ÿ¥ÿ¥õÿÿÿ‚ÿ‚ÿÝÿ¥þÿÿ‚ÿ‚ÿ‚ÿ²ÿû¿ÿûàÿþÝÿøÅÿþãÿéÝÿû‚ÿ‚ÿÿ¥ÿ¥þÿÿëÿÿÿÿÿ¥ÿ¥ÿ¥õÿÿ‚ÿ‚ÿÕÿÿ‚ÿ‚ÿ‚ÿ²ÿû¿ÿû¹ÿøÅÿû­ÿû‚ÿ‚ÿŠÿ¥ÿ¥þÿÿèÿ ÿÿÿ¥ÿ¥õÿÿÿ‚ÿ‚ÿÕÿÿ‚ÿ‚ÿ‚ÿ²ÿû¿ÿû¹ÿøÂÿþ­ÿû‚ÿ‚ÿŠÿ¥ÿ¥þÿÿèÿÿÿñÿÿÿ‚ÿ‚ÿÕÿÿÿ‚ÿ‚ÿ‚ÿµÿû¼ÿþàÿþÝÿøÂÿû³ÿû‚ÿ‚ÿ‡ÿ¥ÿ¥þÿÿèÿÿÿôÿÿÿ‚ÿ‚ÿÒÿÿÿ‚ÿ‚ÿ‚ÿµÿû¹ÿþãÿþÝÿø¼ÿþ¹ÿû‚ÿ‚ÿ„ÿ¥ÿ¥þÿÿåÿÿôÿÿÿ‚ÿ‚ÿÒÿÿÿ‚ÿ‚ÿ‚ÿµÿû¿ÿ×Ýÿø¹ÿþ¿ÿû‚ÿ‚ÿ‚ÿûÿÿÿåÿÿôÿÿÿ‚ÿ‚ÿÒÿÿÿ‚ÿ‚ÿ‚ÿµÿû¿ÿ×Ýÿø¹ÿûÅÿû‚ÿ‚ÿ‚ÿøÿÿÿåÿÿôÿÿÿ‚ÿ‚ÿÒÿÿÿ‚ÿ‚ÿ‚ÿµÿû¼ÿÚÝÿø‚ÿ‚ÿ‚ÿ‚ÿçÿÿâÿÿÿ÷ÿÿ‚ÿ‚ÿÑÿ¥þÿÿ‚ÿ‚ÿ‚ÿµÿû¼ÿþàÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿêÿÿÿâÿÿÿúÿÿÿ‚ÿ‚ÿÑÿ¥þÿÿ‚ÿ‚ÿ‚ÿµÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿêÿÿÿßÿÿúÿÿÿ‚ÿ‚ÿÑÿ¥ÿ¥þÿ‚ÿ‚ÿ‚ÿµÿû‚ÿðÿø‚ÿ‚ÿ‚ÿ‚ÿêÿÿÿßÿÿÿÿÿÿÿ‚ÿ‚ÿÑÿ¥ÿ¥þÿÿ‚ÿ‚ÿ‚ÿ¸ÿû³ÿþõÿûÔÿø‚ÿ‚ÿ‚ÿ‚ÿêÿÿÿßÿÿÿÿÿÿ‚ÿ‚ÿÎÿ¥ÿ¥þÿÿ‚ÿ‚ÿ‚ÿ¸ÿû¹ÿøïÿþ×ÿø‚ÿ‚ÿ‚ÿ‚ÿòÿ¥ÿ¥ÿ¥þÿÿßÿ ÿÿÿÿ‚ÿ‚ÿËÿ¥ÿ¥þÿÿ‚ÿ‚ÿ‚ÿ¸ÿû¼ÿõìÿþÚÿø‚ÿ‚ÿ‚ÿ‚ÿòÿ¥ÿ¥ÿ¥þÿÿßÿ ÿÿÿ‚ÿ‚ÿÈÿ¥ÿ¥þÿÿ‚ÿ‚ÿ‚ÿ¸ÿû¿ÿøæÿûÝÿø‚ÿ‚ÿ‚ÿ‚ÿòÿ¥ÿ¥ÿ¥þÿÙÿÿ‚ÿ‚ÿÂÿ¥þÿÿ‚ÿ‚ÿ‚ÿ¸ÿû¿ÿþàÿûÝÿø‚ÿ‚ÿ‚ÿ‚ÿòÿ¥ÿ¥þÿÿ‚ÿ‚ÿ•ÿ¥þÿÿ‚ÿ‚ÿ‚ÿ¸ÿû¿ÿþàÿûÝÿø‚ÿ‚ÿ‚ÿ‚ÿõÿ¥ÿ¥ÿ¥þÿÿ‚ÿ‚ÿ•ÿ¥þÿÿ‚ÿ‚ÿ‚ÿ¸ÿû¿ÿþàÿûÝÿø‚ÿ‚ÿ‚ÿ‚ÿõÿ¥ÿ¥ÿ¥þÿÿ‚ÿ‚ÿ•ÿ¥þÿÿ‚ÿ‚ÿ‚ÿ¸ÿû¿ÿþãÿøÝÿø‚ÿ‚ÿ‚ÿÍÿ¥ÿ¥²ÿ ¥ÿ¥ÿ¥ÿ¥þÿÿ‚ÿ‚ÿÿÿ‚ÿ‚ÿ‚ÿ¸ÿû¼ÿûïÿõÚÿø‚ÿ‚ÿ‚ÿÍÿ¥ÿ¥ÿ¥µÿ¥ÿ¥ÿ¥þÿÿ‚ÿ‚ÿÿÿÿ‚ÿ‚ÿ‚ÿ»ÿû¹ÿàÚÿø‚ÿ‚ÿ‚ÿÐÿ ¥ÿ¥ÿ¥ÿ¥µÿ¥ÿ¥ûÿÿ‚ÿ‚ÿÿÿÿ‚ÿ‚ÿ‚ÿ»ÿû¶ÿéÔÿø‚ÿ‚ÿ‚ÿÐÿ ¥ÿ¥ÿ¥ÿ¥ÿ¥»ÿ¥ÿ¥ÿ¥ûÿÿ‚ÿ‚ÿÿÿÿ‚ÿ‚ÿ‚ÿ»ÿû‚ÿðÿø‚ÿ‚ÿ‚ÿÐÿ ¥ÿ¥ÿ¥ÿ¥ÿ¥¸ÿ¥ÿ¥þÿÿÿ‚ÿ‚ÿŠÿÿ‚ÿ‚ÿ‚ÿ»ÿû›ÿþÚÿø‚ÿ‚ÿ‚ÿÓÿ¥ÿ¥ÿ¥§ÿÿÿ‚ÿ‚ÿŠÿÿÿ‚ÿ‚ÿ‚ÿ¾ÿû¿ÿþàÿþÚÿø‚ÿ‚ÿ‚ÿÓÿ¥ÿ¥ÿ¥§ÿÿÿ‚ÿ‚ÿŠÿÿÿ‚ÿ‚ÿ‚ÿ¾ÿû¿ÿþÝÿþÝÿø‚ÿ‚ÿ‚ÿÓÿ¥ÿ¥ÿ¥þÿ¾ÿ ÿÿÿúÿÿÿ‚ÿ‚ÿÿ¥ÿ¥þÿÿ‚ÿ‚ÿ‚ÿ¾ÿû¿ÿþàÿûÝÿø‚ÿ‚ÿ‚ÿÓÿ¥ÿ¥þÿÿÿÁÿÿÿÿÿÿÿÿ‚ÿ‚ÿŒÿ¥ÿ¥ÿ¥þÿÿ‚ÿ‚ÿ‚ÿÁÿûÅÿÑÝÿø‚ÿ‚ÿ‚ÿÎÿ ÿÿÿÁÿÿÿÿÿÿÿÿ‚ÿ‚ÿŒÿ¥ÿ¥ÿ¥þÿÿ”ÿÿýÿ‚ÿ‚ÿºÿûÂÿ×Úÿø‚ÿ‚ÿ‚ÿëÿ¥ÿ¥ÿ¥ìÿ ÿÿÿÄÿÿÿ÷ÿÿ‚ÿ‚ÿ‰ÿ¥ÿ¥ÿ¥þÿÿ—ÿÿÿÿÿÿ‚ÿ‚ÿ½ÿû¿ÿþ¶ÿø‚ÿ‚ÿ‚ÿëÿ¥ÿ¥ÿ¥ïÿÿÿÿÿÿÇÿÿÿ‚ÿ‚ÿ‚ÿùÿ¥ÿ¥ÿ¥þÿÿšÿÿÿÿÿÿÿ‚ÿ‚ÿ½ÿû¿ÿþ¶ÿø‚ÿ‚ÿ‚ÿîÿ ¥ÿ¥ÿ¥ÿ¥ÿ¥òÿÿÿÿÿÿÇÿÿÿ‚ÿ‚ÿ‚ÿöÿ¥ÿ¥þÿÿ©ÿÿ÷ÿÿÿÿÿÿÿÿ‚ÿ‚ÿÀÿû‚ÿðÿø‚ÿ‚ÿ‚ÿîÿ ¥ÿ¥ÿ¥ÿ¥ÿ¥òÿÿÿÿÿÿÿÿ¥Íÿ¥þÿÿ‚ÿ‚ÿ‚ÿöÿ¥ÿ¥ÿ¥þÿ¬ÿÿÿÿÿÿÿÿÿúÿÿÿ‚ÿ‚ÿÀÿû˜ÿþÝÿø‚ÿ‚ÿ‚ÿîÿ¥ÿ¥þÿÿÿ¥òÿÿýÿ ÿÿÿÿ¥Íÿ¥þÿÿ‚ÿ‚ÿ‚ÿöÿ¥ÿ¥ÿ¥þÿÿ¯ÿÿÿÿÿÿÿÿ÷ÿÿÿ‚ÿ‚ÿÀÿû˜ÿþÝÿø‚ÿ‚ÿ‚ÿìÿ ÿÿÿÿ¥÷ÿ¥þÿÿýÿ ÿÿÿÿ¥Îÿÿÿ‚ÿ‚ÿ‚ÿóÿ¥ÿ¥ÿ¥þÿÿ¯ÿÿÿÿÿÿÿÿ÷ÿÿÿ‚ÿ‚ÿÀÿû¼ÿÚÝÿø‚ÿ‚ÿ‚ÿìÿ ÿÿÿöÿ¥þÿÿúÿÿÿÿ¥ûÿÿüÿ¥ÿ¥ãÿÿÿ‚ÿ‚ÿ‚ÿðÿ¥ÿ¥þÿÿ²ÿÿÿÿÿ¥ÿ¥ìÿÿÿ‚ÿ‚ÿÀÿû¿ÿ×Ýÿø‚ÿ‚ÿ‚ÿïÿÿÿÿÿÿÿ¥úÿ¥þÿÿúÿÿÿýÿÿÿÿÿÿ¥ÿ¥ÿ¥æÿÿ‚ÿ‚ÿ‚ÿíÿ¥ÿ¥þÿÿ²ÿÿÿÿÿ¥ÿ¥ÿ¥ìÿÿ‚ÿ‚ÿÀÿû¿ÿøãÿþÝÿø‚ÿ‚ÿ‚ÿïÿ ÿÿÿÿùÿ¥ÿ¥þÿÿúÿ ÿÿÿÿ¥þÿÿÿÿÿÿ¥ÿ¥èÿ¥þÿ‚ÿ‚ÿ‚ÿíÿ¥þÿÿÿ´ÿ¥þÿüÿ¥ÿ¥ÿ¥ìÿÿÿ‚ÿ‚ÿÃÿû¿ÿûàÿþÝÿø‚ÿ‚ÿ‚ÿïÿ ÿÿÿÿùÿ¥ÿ¥þÿÿúÿ ÿÿÿÿÿÿÿÿÿÿ¥ÿ¥éÿÿÿ‚ÿ‚ÿ‚ÿèÿÿÿµÿÿÿüÿ¥ÿ¥ÿ¥ìÿÿÿ‚ÿ‚ÿÃÿû¿ÿû¹ÿø‚ÿ‚ÿ‚ÿïÿÿýÿÿùÿ¥ÿ¥þÿÿúÿ#ÿÿÿÿÿÿÿÿÿÿ¥ÿ¥ÿ¥ìÿÿÿ‚ÿ‚ÿ‚ÿèÿÿÿµÿÿÿüÿ¥ÿ¥ÿ¥ìÿÿÿ‚ÿ‚ÿÃÿû¼ÿþàÿþÝÿø‚ÿ‚ÿ‚ÿòÿÿÿýÿÿÿüÿ¥ÿ¥þÿÿ÷ÿ ÿÿÿÿýÿÿÿÿ¥ÿ¥ÿ¥ìÿÿÿ‚ÿ‚ÿ‚ÿåÿÿÿ»ÿÿÿöÿ¥ÿ¥ÿ¥ìÿÿ‚ÿ‚ÿÃÿû¹ÿþãÿþÝÿø‚ÿ‚ÿ‚ÿôÿ¥þÿÿýÿÿÿüÿ¥ÿ¥þÿÿåÿÿÿÿÿ¥ÿ¥ïÿÿÿ‚ÿ‚ÿ‚ÿâÿÿÿ»ÿÿÿöÿ¥ÿ¥ÿ¥ìÿÿ‚ÿ‚ÿÃÿû¿ÿ×Ýÿø‚ÿ‚ÿ‚ÿôÿ¥þÿÿýÿÿÿÿÿ¥ÿ¥ÿ¥þÿßÿ ÿÿÿÿ¥ïÿÿÿ‚ÿ‚ÿ‚ÿâÿÿÿÐÿÿÿôÿÿÿóÿ¥ÿ¥ÿ¥ïÿÿÿ‚ÿ‚ÿÆÿû¿ÿ×Ýÿø‚ÿ‚ÿ‚ÿôÿ¥þÿÿýÿÿÿÿÿ¥ÿ¥ÿ¥þÿßÿÿÿÿÿ¥ÿ¥òÿÿÿ‚ÿ‚ÿ‚ÿßÿÿÐÿ ÿÿÿÿýÿ ÿÿÿÿ¥ôÿ¥ÿ¥ÿ¥ïÿÿÿ‚ÿ‚ÿÆÿû¼ÿÚÝÿø‚ÿ‚ÿ‚ÿôÿ¥þÿÿúÿ ÿÿÿ¥ÿ¥þÿÿßÿÿÿÿÿ¥ÿ¥òÿÿÿ‚ÿ‚ÿ‚ÿäÿ¥ÿ¥þÿÓÿ ÿÿÿÿÿÿÿÿÿÿÿ¥ñÿ¥ÿ¥ÿ¥òÿÿÿ‚ÿ‚ÿÆÿû¼ÿþàÿþÝÿø‚ÿ‚ÿ‚ÿôÿ¥þÿ÷ÿ ÿÿÿÿ¥þÿÿÜÿ ÿÿÿ¥ÿ¥òÿÿÿ‚ÿ‚ÿ‚ÿäÿ¥ÿ¥þÿÓÿ ÿÿÿÿÿÿÿÿÿÿÿ¥ñÿ¥ÿ¥ìÿÿÿ‚ÿ‚ÿÉÿû˜ÿþÝÿø‚ÿ‚ÿ‚ÿõÿÿÿ÷ÿÿÿýÿÿÿÜÿÿÿîÿÿÿ‚ÿ‚ÿ‚ÿáÿ¥þÿÿÙÿÿÿ÷ÿÿÿÿÿÿ¥ÿ¥×ÿÿÿ‚ÿ‚ÿÉÿûÑÿþËÿþÝÿø‚ÿ‚ÿ‚ÿõÿÿÿ÷ÿÿÿýÿÿÿÜÿÿÿñÿÿÿ‚ÿ‚ÿ‚ÿÞÿ¥þÿÿÜÿ ÿÿÿôÿ ÿÿÿ¥ÿ¥Ôÿÿÿ‚ÿ‚ÿÉÿûÑÿþËÿþÝÿø‚ÿ‚ÿ‚ÿõÿÿÿ÷ÿÿÿýÿÿÿÜÿÿÿñÿÿÿ‚ÿ‚ÿ‚ÿÜÿÿÿßÿ ÿÿÿíÿ¥ÿ¥ÿ¥Ôÿÿÿ¸ÿÿÿ‚ÿ›ÿûÑÿþËÿþÝÿø‚ÿ‚ÿ‚ÿ÷ÿ¥þÿÿ÷ÿÿÿýÿÿÿÜÿÿÿñÿÿÿ‚ÿ‚ÿ‚ÿÛÿ¥þÿçÿ¥ÿ¥ÿ¥þÿÿµÿÿÿ»ÿ ÿÿÿÿ‚ÿžÿûÑÿÅÝÿø‚ÿ‚ÿ‚ÿ÷ÿ¥þÿÿôÿÿýÿÿÿÙÿÿñÿÿÿ‚ÿ‚ÿ‚ÿÛÿ¥þÿçÿ¥ÿ¥ÿ¥þÿ²ÿÿÿ¾ÿÿÿÿÿÿ‚ÿžÿûÑÿÅÝÿø‚ÿ‚ÿ‚ÿ÷ÿ¥þÿñÿ ÿÿÿÿÖÿÿÿ÷ÿ ÿÿÿÿ¥‚ÿ‚ÿ‚ÿÚÿÿÿÿ¥îÿ¥ÿ¥ÿ¥þÿÿÀÿ¥ÿ¥õÿÿÁÿÿÿÿÿÿÿ‚ÿžÿûÑÿÅÝÿø‚ÿ‚ÿ‚ÿõÿÿñÿ ÿÿÿÿÖÿÿÿùÿ¥þ ÿÿÿÿ¥‚ÿ‚ÿ‚ÿÚÿ ÿÿÿÿ¥ñÿ¥ÿ¥ÿ¥þÿÿÃÿ¥ÿ¥ÿ¥õÿÿÿÄÿÿÿúÿÿÿ‚ÿ¡ÿûÑÿûÑÿûÝÿø‚ÿ‚ÿ‚ÿõÿÿñÿ ÿÿÿÿÓÿÿüÿ¥ÿ¥þÿÿÿ¥‚ÿ‚ÿ‚ÿ×ÿ ÿÿÿÿ¥ôÿ¥ÿ¥ÿ¥þÿÿ½ÿ¥ÿ¥ÿ¥øÿÿÿÄÿÿÿúÿÿÿ‚ÿ¡ÿûÑÿþËÿþÝÿø‚ÿ‚ÿ‚ÿøÿÿÿîÿÿÿÐÿ ÿÿÿÿ¥þ ÿÿÿÿ¥‚ÿ‚ÿ‚ÿ×ÿÿÿðÿ¥ÿ¥ÿ¥þÿÿ½ÿ ¥ÿ¥ÿ¥ÿ¥ûÿÿÿÄÿÿÿ÷ÿÿÿ‚ÿ¤ÿûÑÿþËÿþÝÿø‚ÿÌÿÿÿ‚ÿ¶ÿÿÿ²ÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿÐÿÿÿóÿ¥ÿ¥þÿÿäÿ¥ÿ¥ÿ¥Üÿ¥ÿ¥ÿ¥ûÿÿÿÇÿÿÿôÿÿÿ‚ÿ¤ÿû‚ÿðÿø‚ÿÌÿÿÿ‚ÿ¶ÿÿÿ²ÿ ÿÿÿÿ‚ÿ‚ÿ‚ÿÍÿÿÿöÿ¥ÿ¥ÿ¥þÿÿðÿ¥÷ÿ¥ÿ¥Öÿ ¥ÿ¥ÿ¥ÿ¥þÿÿÇÿÿÿñÿÿÿ‚ÿ§ÿû‚ÿðÿø‚ÿÌÿÿÿ‚ÿ¶ÿÿÿ¯ÿ ÿÿÿ‚ÿ‚ÿ‚ÿÍÿÿÿùÿ ¥ÿ¥ÿ¥ÿ¥þÿÿóÿ¥ÿ¥÷ÿ¥ÿ¥Öÿ ¥ÿ¥ÿ¥ÿ¥þÿÿÿÊÿÿÿñÿÿÿ‚ÿ§ÿû‚ÿðÿø‚ÿÌÿÿÿ‚ÿ¹ÿÿÿ¬ÿ ÿÿÿ‚ÿ‚ÿ‚ÿÍÿ ÿÿÿùÿ¥ÿ¥þÿÿðÿ¥ÿ¥ÿ¥ýÿ¥ÿ¥ÿ¥Ðÿ¥ÿ¥ÿ¥þÿÿÿÍÿÿÿîÿÿÿ‚ÿªÿû‚ÿðÿø‚ÿÏÿ ÿÿÿÿ‚ÿ¼ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿéÿÿÿôÿÿÿíÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥Íÿ¥ÿ¥ÿ¥þÿÿÍÿÿÿîÿÿÿ‚ÿªÿû‚ÿðÿø‚ÿÏÿ ÿÿÿÿ‚ÿ¼ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿæÿÿÿ÷ÿÿêÿ ¥ÿ¥ÿ¥ÿ¥ÿ¥Êÿ¥ÿ¥ÿ¥þÿ ÿÿÿÿÙÿÿÿëÿÿÿ‚ÿªÿû‚ÿðÿø‚ÿÏÿ ÿÿÿÿ÷ÿÿÿ‚ÿÐÿ¥þÿÿ‚ÿ‚ÿ‚ÿ‚ÿãÿÿýÿ ÿÿÿçÿ ¥ÿ¥ÿ¥ÿ¥¿ÿÿÿÿÿÿÜÿÿÿèÿÿÿ‚ÿ­ÿû‚ÿðÿø‚ÿÏÿ ÿÿÿÿ÷ÿÿÿ‚ÿÐÿ¥þÿÿ‚ÿ‚ÿ‚ÿ‚ÿãÿÿÿÿÿÿÿ—ÿ ÿÿÿÿÜÿÿåÿÿÿ‚ÿ­ÿû‚ÿðÿø‚ÿÏÿ ÿÿÿÿúÿ ÿÿÿ‚ÿÐÿ¥þÿÿ‚ÿ‚ÿ‚ÿ‚ÿàÿ ÿÿÿÿ‹ÿÿÿâÿÿÿâÿÿÿ‚ÿ°ÿû‚ÿðÿø‚ÿÏÿ ÿÿÿÿúÿ ÿÿÿ‚ÿÑÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿØÿ ÿÿÿåÿÿÿßÿÿ‚ÿ°ÿû‚ÿðÿø‚ÿÏÿ ÿÿÿÿúÿ ÿÿÿ‚ÿÑÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÕÿ ÿÿÿèÿÿÜÿÿÿ‚ÿ³ÿû‚ÿðÿø‚ÿÏÿ ÿÿÿÿúÿ ÿÿÿÿ‚ÿÔÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÒÿ ÿÿÿëÿÿÜÿÿÿ‚ÿ³ÿû‚ÿðÿø‚ÿÏÿÿýÿÿüÿ¥þ ÿÿÿÿ‚ÿÖÿ¥þÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿæÿ¥ÿ¥ÿ¥òÿÿÿîÿÿÿÙÿÿÿ‚ÿ¶ÿû‚ÿðÿø‚ÿÏÿÿÿÿ¥þÿüÿ¥þ ÿÿÿÿ‚ÿÖÿ¥þÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿãÿ¥ÿ¥ïÿÿÿñÿ ÿÿÿÿ¥Ýÿÿÿ‚ÿ¶ÿû‚ÿðÿø‚ÿÑÿ¥þÿÿÿ¥þÿÿÿÿ¥þ ÿÿÿÿ‚ÿÖÿ¥þÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿàÿ¥ÿ¥ÿ¥òÿ ÿÿÿ÷ÿ ÿÿÿÿ¥Úÿÿÿ‚ÿ¶ÿû‚ÿðÿø‚ÿÑÿ¥þÿÿÿ¥þÿÿÿÿÿÿÿÿ‚ÿ×ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿàÿ¥ÿ¥ÿ¥ïÿ ÿÿÿýÿÿÿÿÿÿ¥×ÿÿÿ‚ÿ¹ÿû‚ÿðÿø‚ÿÑÿ¥þÿÿÿ¥þÿÿÿÿÿÿÿÿ‚ÿ×ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÝÿ¥ÿ¥ÿ¥ïÿÿÿÿÿÿÿÿçÿ¥ïÿ ÿÿÿ‚ÿ¼ÿû‚ÿðÿø‚ÿÑÿ¥þÿÿÿ¥þÿÿÿÿÿÿÿ¥þÿ‚ÿ×ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÝÿ¥ÿ¥ÿ¥ìÿÿÿÿÿÿÿÿ¥îÿ ¥ÿ¥ÿ¥ÿ¥ÿ¥òÿÿÿ‚ÿ¼ÿû‚ÿðÿø‚ÿÑÿ¥þÿÿÿ¥ÿ¥þÿÿÿÿÿÿ¥þÿ‚ÿÚÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ×ÿ¥ÿ¥ÿ¥ïÿÿÿÿÿÿ¥ÿ¥èÿ ¥ÿ¥ÿ¥ÿ¥ÿ¥òÿÿÿ‚ÿ¿ÿû‚ÿðÿø‚ÿÒÿ ÿÿÿÿ¥ÿ¥þÿÿÿÿÿÿ¥þÿÿ‚ÿãÿ ÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ×ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ñÿ ¥ÿ¥ÿ¥ÿ¥âÿ ¥ÿ¥ÿ¥ÿ¥õÿÿÿÿÿÿÿÿÿ‚ÿÑÿû‚ÿðÿø‚ÿÒÿ ÿÿÿÿ¥ÿ¥þÿÿÿÿÿÿ¥þÿÿ‚ÿæÿ ÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÑÿ ¥ÿ¥ÿ¥ÿ¥îÿ¥ÿ¥ÿ¥Üÿ ¥ÿ¥ÿ¥ÿ¥õÿÿÿÿÿÿÿÿ‚ÿÑÿû‚ÿðÿø‚ÿÒÿÿÿüÿ¥þÿÿÿÿÿÿ¥þÿÿ‚ÿéÿ ÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿËÿ¥ÿ¥ÿ¥ñÿ¥ÿ¥ÿ¥Öÿ¥ÿ¥ÿ¥õÿÿÿÿÿÿÿÿ‚ÿÑÿû‚ÿðÿø‚ÿÒÿÿÿüÿ¥þÿÿÿüÿ¥þÿÿ„ÿ¥ÿ¥ìÿÿüÿ¥ÿ¥ÿ¥‚ÿ‚ÿ‚ÿ‚ÿ‚ÿºÿ ¥ÿ¥ÿ¥ÿ¥Óÿ¥ÿ¥ÿ¥æÿÿÿ‚ÿÔÿû‚ÿðÿø‚ÿÒÿÿÿüÿ¥þÿÿÿüÿ¥þÿÿ‡ÿ ¥ÿ¥ÿ¥ÿ¥òÿÿÿÿÿ¥ÿ¥ÿ¥‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ´ÿ¥ÿ¥Ðÿ¥ÿ¥ÿ¥æÿÿÿ‚ÿÔÿû‚ÿðÿø‚ÿÒÿÿÿüÿ¥þÿÿÿüÿ¥þÿÿ‡ÿ ¥ÿ¥ÿ¥ÿ¥òÿÿÿÿÿ¥ÿ¥ÿ¥‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿúÿ¥ÿ¥ÿ¥éÿ ÿÿÿ‚ÿ×ÿû‚ÿðÿø‚ÿÔÿ¥þÿÿ÷ÿÿùÿ¥þÿÿŠÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥øÿÿÿüÿ¥ÿ¥ÿ¥‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿúÿ¥ÿ¥ãÿÿÿÜÿ ÿÿÿˆÿû‚ÿðÿø‚ÿÔÿ¥þÿçÿ¥þÿÿŠÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥øÿÿÿÿÿ¥ÿ¥ÿ¥‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÑÿÿÿßÿ ÿÿÿˆÿû‚ÿðÿø‚ÿÔÿ¥þÿçÿ¥þÿÿŠÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥þÿÿÿÿÿÿÿ¥ÿ¥ÿ¥‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÑÿÿÿâÿÿÿÿÿÿ‹ÿû‚ÿðÿø‚ÿÔÿ¥þÿåÿÿÿŠÿ¥ÿ¥ÿ¥þÿÿÿÿÿÿÿÿÿ¥ÿ¥ÿ¥‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿËÿÿâÿÿÿÿÿÿ‹ÿû‚ÿðÿø‚ÿÔÿ¥þÿåÿÿÿŠÿ¥ÿ¥ûÿÿÿÿÿÿÿ¥ÿ¥ÿ¥‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÅÿÿÿèÿÿÿýÿ ÿÿÿŽÿû‚ÿðÿø‚ÿÕÿÿÿâÿÿ‚ÿ ÿÿÿÿüÿ¥ÿ¥‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÜÿ ¥ÿ¥ÿ¥ÿ¥ÿ¥õÿÿÿèÿÿÿúÿÿÿŽÿû‚ÿðÿø‚ÿÕÿÿÿâÿÿ‚ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÌÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥õÿÿÿëÿÿÿ÷ÿÿŽÿû‚ÿðÿø‚ÿÕÿÿÿâÿÿÿˆÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÀÿ ¥ÿ¥ÿ¥ÿ¥øÿÿÿîÿÿÿôÿÿÿ‘ÿû‚ÿðÿø‚ÿÕÿÿÿâÿÿÿ‹ÿ ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ½ÿ ¥ÿ¥ÿ¥ÿ¥ûÿ ÿÿÿñÿÿÿôÿÿÿ‘ÿû‚ÿðÿø‚ÿÕÿÿÿâÿÿÿ‹ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ·ÿ ¥ÿ¥ÿ¥ÿ¥ûÿ ÿÿÿôÿÿÿñÿÿ‘ÿû‚ÿðÿø‚ÿÕÿÿÿäÿ¥þÿÿŽÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ±ÿ ¥ÿ¥ÿ¥ÿ¥ûÿÿÿ÷ÿÿÿîÿÿÿ”ÿû‚ÿðÿø‚ÿÕÿÿÿäÿ¥þÿÿ“ÿ¥ÿ¥þÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ®ÿ¥ÿ¥ÿ¥øÿÿÿüÿ¥þ ÿÿÿÿ¥òÿ ÿÿÿ—ÿû‚ÿðÿø‚ÿÕÿÿÿäÿ¥þÿÿ“ÿ¥þÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¨ÿ¥õÿÿÿÿÿÿÿÿÿ¥ÿ¥ïÿÿÿÿÿÿÿ£ÿû‚ÿðÿø‚ÿÕÿÿÿäÿ¥þÿÿ“ÿ¥þÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ—ÿÿÿÿÿÿÿÿ¥ÿ¥ÿ¥ïÿÿÿÿÿÿÿ¦ÿû‚ÿðÿø‚ÿÕÿÿÿäÿ¥þÿÿ–ÿ¥þÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ“ÿ¥ÿ¥ÿ¥úÿ¥ÿ¥ÿ¥éÿ ÿÿÿÿ¦ÿû‚ÿðÿø‚ÿÕÿÿÿâÿÿÿ¦ÿÿöÿ¥þÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿ¥ñÿ¥ÿ¥ÿ¥æÿ ÿÿÿ©ÿû‚ÿðÿø‚ÿÕÿÿÞÿ¥þÿ©ÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿúÿ¥ÿ¥àÿÿÿ©ÿû‚ÿðÿø‚ÿÕÿÿÞÿ¥þÿÿ¯ÿÿÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÑÿÿÿ¬ÿû‚ÿðÿø‚ÿ×ÿ¥þÿÞÿ¥þÿÿ¯ÿÿÿýÿ ÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÎÿÿÿ¬ÿû‚ÿðÿø‚ÿØÿÿÿÞÿ¥þÿÿ±ÿ¥þÿÿùÿ¥þÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÈÿÿÿ¯ÿû‚ÿðÿø‚ÿØÿÿÿÞÿ¥þÿÿ´ÿ¥þÿÿùÿ ¥ÿ¥ÿ¥ÿ¥‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÉÿ ÿÿÿ²ÿû‚ÿðÿø‚ÿØÿÿÿÞÿ¥ÿ¥þÿ´ÿ¥þÿóÿ¥ÿ¥‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿàÿ¥æÿÿÿ²ÿû‚ÿðÿø‚ÿØÿÿÿÙÿÿ·ÿ¥þÿÿóÿ¥ÿ¥‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿãÿ¥ÿ¥ÿ¥éÿ ÿÿÿµÿû‚ÿðÿø‚ÿØÿÿÿÙÿÿºÿ¥ÿ¥þÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÐÿ ¥ÿ¥ÿ¥ÿ¥éÿ ÿÿÿÿ»ÿû‚ÿðÿø‚ÿØÿÿÿÙÿÿÿýÿÿÆÿ¥ÿ¥þÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÊÿ ¥ÿ¥ÿ¥ÿ¥ÿ¥ìÿÿÿÿÿÿÁÿû‚ÿðÿø‚ÿÚÿ¥þÿÿÙÿÿÿÿÿÿÿÌÿ¥ÿ¥ÿ¥þÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÇÿ ¥ÿ¥ÿ¥ÿ¥ÿ¥éÿÿÿÿÿÿÿÿÍÿû‚ÿðÿø‚ÿÚÿ¥þÿÿÖÿÿÿÿÿÿÌÿ¥ÿ¥þÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÄÿ ¥ÿ¥ÿ¥ÿ¥ÿ¥éÿÿÿÿÿÿÿÿÐÿû‚ÿðÿø‚ÿíÿÿóÿ¥þÿÓÿÿÿÿÿÿÿÏÿ¥ÿ¥þÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¾ÿ ¥ÿ¥ÿ¥ÿ¥ãÿÿÿÿÿÿÿñÿÿÿÿÿÿÿÿÿÿû‚ÿðÿø‚ÿðÿÿÿôÿÿÿÐÿÿÿÿ¥þÿÿÒÿ¥ÿ¥þÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¸ÿ ¥ÿ¥ÿ¥ÿ¥Ýÿ5ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿû‚ÿðÿø‚ÿóÿ ÿÿÿÿ÷ÿÿÿÆÿ¥þÿÿÕÿ¥ÿ¥þÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿµÿ¥ÿ¥Ôÿÿÿÿÿÿÿÿÿëÿû‚ÿðÿø‚ÿóÿ ÿÿÿÿ÷ÿÿÿÆÿ¥þÿÿÒÿ¥þÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿüÿÿÿÿÿÿèÿû‚ÿðÿø‚ÿóÿ ÿÿÿÿ÷ÿÿÿÆÿ¥þÿÿÐÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÿ!¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥þÿóÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ú‚ÿðÿø‚ÿóÿ ÿÿÿÿ÷ÿÿÁÿÿÿÓÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿšÿ"¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥îÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ú‚ÿðÿø‚ÿóÿÿÿÿÿÿúÿÿÀÿ¥þÿÿÖÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‘ÿ ¥ÿ¥ÿ¥ÿ¥÷ÿ¥ÿ¥îÿ¥ýÿ ¥ÿ¥ÿ¥ÿ¥ÿ¥ú‚ÿðÿø‚ÿóÿÿýÿÿÿýÿÿÿÀÿ¥þÿÿåÿÿúÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÌÿû‚ÿðÿø‚ÿöÿÿÿüÿ¥þÿÿÿÿÿ¾ÿ ÿÿÿëÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÌÿû‚ÿðÿø‚ÿöÿÿÿüÿ¥þ ÿÿÿÿ¸ÿ ÿÿÿÿôÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÉÿû‚ÿðÿø‚ÿöÿÿÿúÿ ÿÿÿÿµÿÿÿÿÿÿýÿ ÿÿÿÿÿ¥þÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÆÿû‚ÿðÿø‚ÿöÿÿöÿ¥þÿÿ¬ÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ·ÿû‚ÿðÿø‚ÿøÿ¥þÿóÿ¥ÿ¥¦ÿ¥ÿ¥þÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ´ÿû‚ÿðÿø‚ÿøÿ¥þÿ“ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥ÿ¥‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿµÿû‚ÿðÿø‚ÿùÿÿÿÿ ¥ÿ¥ÿ¥ÿ¥‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ²ÿû‚ÿðÿø‚ÿùÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿµÿû‚ÿðÿø‚ÿùÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ²ÿû‚ÿðÿø‚ÿûÿ¥þÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ²ÿû‚ÿðÿø‚ÿüÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ²ÿû‚ÿðÿøÿÿÿ÷ÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ²ÿû‚ÿðÿø’ÿ ÿÿÿÿýÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿû‚ÿðÿø”ÿ¥þÿÿÿÿÿÿÿÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ¯ÿû‚ÿðÿø•ÿÿÿÿÿÿÿÿÿ‚ÿ¹ÿø‚ÿ‚ÿ¯ÿû‚ÿ‚ÿ¯ÿû‚ÿ‚ÿ¯ÿû‚ÿðÿø•ÿÿÿúÿÿÿ‚ÿ¶ÿø‚ÿ‚ÿ¯ÿû‚ÿ‚ÿ¯ÿû‚ÿ‚ÿ¯ÿû‚ÿðÿø˜ÿÿÿ‚ÿ¤ÿø‚ÿ‚ÿ¯ÿû‚ÿ‚ÿ¯ÿû‚ÿ‚ÿ¯ÿû‚ÿðÿø›ÿ ÿÿÿ‚ÿ¤ÿø‚ÿ‚ÿ¯ÿû‚ÿ‚ÿ¯ÿû‚ÿ‚ÿ¯ÿû‚ÿðÿø›ÿÿÿ‚ÿ¡ÿø‚ÿ‚ÿ¯ÿû‚ÿ‚ÿ¯ÿû‚ÿ‚ÿ¯ÿû‚ÿðÿøžÿ ÿÿÿ‚ÿ¡ÿø‚ÿ‚ÿ¯ÿû‚ÿ‚ÿ¯ÿû‚ÿ‚ÿ¯ÿû‚ÿðÿø¡ÿ ÿÿÿ‚ÿžÿø‚ÿ‚ÿ¯ÿû‚ÿ‚ÿ¯ÿû‚ÿ‚ÿ¯ÿû‚ÿðÿøªÿÿÿÿÿÿ‚ÿ›ÿø‚ÿ‚ÿ¯ÿû‚ÿ‚ÿ¯ÿû‚ÿ‚ÿ¯ÿû‚ÿðÿø¿ÿ"ÿÿÿÿÿÿÿÿÿÿÿ‚ÿ˜ÿø‚ÿ‚ÿ¯ÿû‚ÿ‚ÿ¯ÿû‚ÿ‚ÿ¯ÿû‚ÿðÿö\ÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿÿ‚ÿ’ÿø‚ÿ‚ÿ¯ÿû‚ÿ‚ÿ¯ÿû‚ÿ‚ÿ¯ÿû‚ÿðÿ‚‚‚‚‚‚‚‚‚‚–‚ÿðÿ‚‚‚‚‚‚‚‚‚‚–‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿüÿø‚ÿ‚ÿÿø‚ÿ‚ÿÙÿøãÿø‚ÿ‚ÿÙÿøãÿø‚ÿ‚ÿÍÿþæÿøŒÿþøÿû‚ÿ‚ÿÊÿøéÿûøÿû‚ÿ‚ÿåÿìïÿûøÿû‚ÿ‚ÿåÿìïÿûøÿû‚ÿ‚ÿÖÿûìÿûøÿþ’ÿûõÿû‚ÿ‚ÿÐÿõìÿûòÿþ‚ÿ‚ÿåÿþøÿõòÿþòÿþ‚ÿ‚ÿåÿþøÿøïÿþòÿû‚ÿ‚ÿÙÿûïÿûõÿû˜ÿûòÿû‚ÿ‚ÿÊÿûìÿûòÿû‚ÿ‚ÿëÿþòÿøõÿûòÿû‚ÿ‚ÿëÿþòÿøõÿûòÿû‚ÿ‚ÿÜÿøïÿûòÿû›ÿûïÿû‚ÿ‚ÿÍÿûïÿøòÿû‚ÿ‚ÿÖÿûøÿøòÿø‚ÿ‚ÿÜÿøõÿûïÿû‚ÿ‚ÿâÿþþÿûòÿûïÿûžÿøïÿû‚ÿ‚ÿÍÿûïÿøòÿø‚ÿ‚ÿÙÿûøÿøòÿø‚ÿ‚ÿÜÿûõÿøïÿû‚ÿ‚ÿåÿþûÿûòÿûïÿø¡ÿøïÿû‚ÿ‚ÿÍÿûïÿûìÿû‚ÿ‚ÿÙÿûøÿûìÿû‚ÿ‚ÿÜÿûõÿûìÿû‚ÿ‚ÿåÿþûÿûòÿûïÿø¡ÿøïÿø‚ÿ‚ÿÐÿûïÿûìÿû‚ÿ‚ÿÙÿûøÿûìÿû‚ÿ‚ÿßÿþïÿûìÿû‚ÿ‚ÿèÿþøÿûõÿøïÿø¡ÿøïÿø‚ÿ‚ÿÐÿûïÿûìÿû‚ÿ‚ÿÜÿûõÿûìÿû‚ÿ‚ÿâÿõõÿûìÿû‚ÿ‚ÿëÿþõÿûõÿøïÿø¡ÿøïÿø‚ÿ‚ÿÐÿûïÿûìÿû‚ÿ‚ÿÜÿþòÿûìÿû‚ÿ‚ÿßÿõøÿûìÿû‚ÿ‚ÿîÿûõÿûõÿøïÿø¡ÿøïÿø‚ÿ‚ÿÐÿûïÿûìÿû‚ÿ‚ÿßÿûòÿûìÿû‚ÿ‚ÿÜÿøøÿûìÿû‚ÿ‚ÿîÿþòÿûõÿøïÿø¡ÿøïÿø‚ÿ‚ÿÐÿûïÿûìÿû‚ÿ‚ÿßÿþïÿûìÿû‚ÿ‚ÿÙÿûøÿûìÿû‚ÿ‚ÿñÿþïÿûõÿøïÿø¡ÿøïÿû‚ÿ‚ÿÍÿûïÿûìÿû‚ÿ‚ÿâÿþìÿûìÿû‚ÿ‚ÿÖÿþøÿûìÿû‚ÿ‚ÿñÿÝûÿûïÿøžÿûïÿû‚ÿ‚ÿÍÿûïÿøòÿû‚ÿ‚ÿâÿþéÿøòÿø‚ÿ‚ÿÖÿþõÿûïÿû‚ÿ‚ÿÜÿûòÿûïÿû›ÿûòÿû‚ÿ‚ÿÊÿûìÿûòÿû‚ÿ‚ÿåÿþãÿûòÿû‚ÿ‚ÿÓÿþõÿûòÿû‚ÿ‚ÿÙÿûòÿøòÿû›ÿûòÿû‚ÿ‚ÿÊÿûìÿûòÿû‚ÿ‚ÿèÿþìÿþøÿûòÿû‚ÿ‚ÿÖÿþòÿûòÿû‚ÿ‚ÿÙÿûïÿûòÿþ•ÿûõÿþ‚ÿ‚ÿÇÿûéÿûøÿû‚ÿ‚ÿèÿãõÿûøÿû‚ÿ‚ÿèÿûõÿûïÿûøÿû‚ÿ‚ÿÖÿûìÿþõÿûÿõ‚ÿ‚ÿÍÿììÿò‚ÿ‚ÿèÿãïÿò‚ÿ‚ÿåÿòãÿò‚ÿ‚ÿÓÿûéÿõ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿìÿéÅÿãéÿéûÿé‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÆÿø°ÿòÚÿøãÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÆÿø°ÿòÚÿøãÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÆÿø­ÿõÚÿûàÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÆÿø­ÿòÝÿûàÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÆÿøªÿõÝÿþÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÅÿòòÿõ­ÿøªÿòãÿûÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿËÿòæÿõ³ÿø§ÿõãÿûÝÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÎÿõÝÿõ¶ÿøÝÿìàÿòéÿûÚÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÎÿõïÿþïÿõ¹ÿøàÿþòÿøàÿõéÿûÚÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÑÿõïÿøòÿõ¹ÿøãÿþïÿõãÿõéÿûÚÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÑÿõòÿõïÿõ¼ÿøæÿûìÿøàÿõïÿû×ÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÔÿõïÿõïÿõ¼ÿøéÿûéÿõãÿõïÿû×ÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÔÿõïÿõïÿõ¼ÿøéÿ×ãÿòõÿûÔÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÔÿõïÿõìÿø¼ÿøéÿ×àÿõõÿûÔÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÔÿõïÿõìÿø¼ÿøéÿû¹ÿøõÿûÔÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÔÿõïÿõìÿø¼ÿøéÿû¹ÿõûÿûÑÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÔÿõìÿøìÿø¼ÿøéÿû¹ÿòþÿûÑÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÔÿõìÿûéÿø¼ÿøéÿø¹ÿõþÿþÎÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÔÿõìÿûìÿõ¼ÿøéÿøàÿþÝÿïÎÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÑÿøìÿûìÿõ¼ÿøéÿõæÿþ×ÿòÎÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÑÿõïÿøïÿø¹ÿøéÿòìÿû×ÿõËÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÎÿøòÿûþÿþòÿõ¹ÿøæÿòòÿûÑÿøËÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÎÿõøÿøþÿûøÿõ¶ÿøæÿàÎÿøËÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿËÿìõÿì³ÿøãÿæËÿûÈÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÅÿøéÿø­ÿøÚÿø¿ÿþÈÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÆÿø‚ÿÒÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÆÿø‚ÿÒÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÆÿø‚ÿÒÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÆÿø‚ÿÒÿø‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÆÿé‚ÿðÿé‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿ‚ÿÞÿ€ endstream endobj 104 0 obj << /Type /XObject /Subtype /Image /Name /Ma0 /Filter [/RunLengthDecode] /Width 507 /Height 612 /ColorSpace /DeviceGray /BitsPerComponent 8 /Length 106 0 R >> stream ‚‚‚ƒ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ‚ÿ‚ÿ‚ÿ„ÿ€ endstream endobj 110 0 obj << /Length 2239 /Filter /FlateDecode >> stream xÚÅXYÜ6~Ÿ_¡}Ón†—DÊ‹}XÛñ“Mà ²€ãš=­DG[‡g'¿>U,êjk½~X`Ñ@³H‹uñcQV×Y!9S\­âšOj­­#{°J”`BÊ/$a9à#qóíÝÍDzy$"™f,Ñ&J•fRdQQß¼ÿÀ£#L~q–@=kA2Y\VEïn~ÚˆY¤•!Tr׃ð£ L?ìfH j¯3ÄíF+éMj(ñ×/:ÝÂbãt±ãôÆ•&Ì€{.XbìW©lÔ¾JDfÑŠéÞ•Í€‘ÍžY»à z<ƒ±5žÁ0jßžö°KfM:Yù)¯\Sìi¢ ß'®Yø3žY‚GØ%§½/½í¥¬Ë¼¢¹"¯Ÿ‡²m¼=ç´M-ÁV0€û„€ƒl&0g·‡D'ñZ­¤ß–íø©¬*wx›7ÅmOÃùåÒà‹8/Î4‚øíÝ«W¯ïˆ,ò‰ ÜIGWƒ9C—ùëU}ŽÂ†²?=…‰IÓ¡=@ƒ[Hß”ôíÆÊ³H©HâçÅP=ݦI îRZħ¶£iÐ柨3EiŒ"¶+Ë\>®óþëiò}¢? S¤§”apjÛ¦ r‡nt$àñ쇲*ÿÀLú<#T ?ãVÕBàvÒáØ6º |Ú)+ã_ü¾Ò$qjyÐÓñ/©Ew`ûó;jIÌa‘CÃyçˆ{wÄ̳"þT¶Õä/êD- >R² $ rhïCŸ¢w\wG0E§*~ÓÖó´æñV@AUŽ÷4B¡âåÎe)E”¿-XJù@sp¹âºt®ßø\E î[Tõþ9L2¡ Éžœ½E]Èè$`•ÉìÖ?düйÚùLR*î뼪ÔS*ÁàØ{@B㉓×i@³Ë]¼¹¦$·`ת äb') ›‹¢ÓºÃ•$õU]µYŸÀ]l¯$ÈlS%2[”Pb? ©ž/¾«Ý|žáùŽ ¶.¸A(Ä€%Þ¥Ë{ra9ÓÊ༶q4ÑvG8v áK”/;7á«ó‡¦Æc(y±06~˜ÊÞÿ £˜Éÿ;pB Æür,2&–‚è cC(Ð;”ÝH-@黡 ýèÖ5ÔMSÕ$¬d65‘J ãPCÕôñË2é!~+ÚON+ÃÀ7oj½j¡Žúiž:LR+±S™Ñ1\¬_b ®øT„büuù0z¼Ó&6Ïáöà:~ÙÖ—¼+{ :¥Ûæ B€Èïû¶»à€~˜ØyTÞÄ~á2îœÏT² ^*ò9¤(ˆx2µŸ!Þ¢{Æ$Vk3S*Ž„w°Óc9œ¯TÜ«@‰Ú ç6¬:ºÃ„wjОmi@Ô¾èÊûI~éíīޟ?ÜÑ£|÷{ðGs$†E‘<¬(ë T!—üá6‰óÅoyõÐv°k™”ËøEKËíõͼ%¨¦\·H=éÖy7ä¢Ï»¶žt ÷yí¦  €ðеcž³ cpìKÅïôÚƒçœ!xë“àqˆO->¸ž°k0D5¸i­F¾áéRú;;/ü9Œ‚§‚ ²¡ÞeS}©Â¦˜žj//²ÆáÝÖ¬Vñ? qЈ¾ä³iüæÅ÷D¼û1E"¬,ÎðÖ†yì`ÛÃýD^N%©…˜®‡³Ð^r:Ì„¸Ï6î°¢­PçÄÕ쥧"دmÛ߉*›½Jehï=Îcm™AJÄçvìzDé#‚zuÙÀAé‰ë‚x£¤R¸9î 3©@‡yNò,Îçgp Íû”ÇQ_Ñx‘ç0µ¬€Bý°k«ŸÑ!kˆ–‚Y1ß%ÃØÝ·T£ï¼ì%<€ç[e ‘óZÉ$1ûE¿œ'sÇX,늲w4êO û8–X‡5CO|TUâJJ; ¶i×ÓàÑ]œ‡*Xsvù-d,`äM¶ÍÞÛ…tÉx\âéÃ=§<†1½Œ_GîóÞc%½è|$€fÜø|Ç Ó¹½†Çiºryç5ƒN˜¢N€¿¼v2è:Ïþk Í%ƒ"ÞB²yÞn(´˜´A¼Á3K^¶MQAÝ‹~Þ«L&èT"|xÃWƒÔ"¸©å>ñ=Gí™BäóGäºÐ'nÇ BsØK|ÝAÒÌð¹Â+Ú#žäÎù@›Ì‘ï—M=ñùK×)‡ZË\½Ùý3Ü?Á¥¢Ç´TÆçë²’>ä*|z7}9<NcS`ªù×!ðBàÑ’~^ÊÙµHãÃ’§ñ߉ó膼¬¼¼<¼Ë/Ë2ÿ&TfþÈp•4cï¶Ÿ‚çïÄè¢Îy?eËTâW|s•Çé#qù½n®gA›ûl½ÕªdÂîî#1ƒBÕcËòh÷‘hà(×ŸŠ¶<MÁ6ç]˜ëÒõO®C5 endstream endobj 107 0 obj << /Type /XObject /Subtype /Form /FormType 1 /PTEX.FileName (./figure5_new.pdf) /PTEX.PageNumber 1 /PTEX.InfoDict 111 0 R /BBox [0 0 841.92 594.96] /Resources << /ProcSet [ /PDF /ImageB /ImageC /ImageI /Text ] /Font << /F0 112 0 R/F1 113 0 R>> >> /Length 12182 /Filter /FlateDecode >> stream x^ÕM¯4Éq÷ó+Þ¥½0Ý]ùUµ5d¼±Mx#h!Ë!CÔEƒð¿wxÎÉê{=CÞ™pî3Ý]YYu*3"22j\ýW×üñºÿÏŸýÛŸÞ?ôÏùþãw¿ùIüöþÿ÷¿ÿéý«þúïûÏ×ýçßÖw^úèW¿z½Úúñ‡ûw¿Æû_×ê:ЯÞãÕÃ_ü>¾òñþÆ×WnçWîó+Ý<ÛW^ßÚûv¸ó[s×úÂóõµ¹ùþÚy|mn¶¯Ý™ß¾ÞÝü07žîMxù÷áÓ½ _nn³»c^¯¯í­·»>¾¶·š»î_Û[ß¾>¾57¿vg­oÍ_»³®¯Í¯¯Ý9¿ã×ÞœÇ׿ÎöõôÎþµ¹s¸7Ó<}üÍîNx¹½ðéî„£uóõrwÂÑzø;~mîjîN8Rw'©‡—»³Ì>ûß8R‡×˽ GêáçŽÔ7»;áh=<Üp´~š—»ŽÖÃ>üƯü~¹;áH=|¸;áHý2ww'ì³ÛèÞ„#õpp¤ÎÍ7–ºÏ&½ ZéÁƒ¾­ó`§'A«<èŸj/tCáE?6[ã›/únÖøæ·ûq˜ÝøF7¶Æ7[ã›­ñ³™­ñÍÖøf_§ßØ?no¶Æ7[ã›­ñ‡ÝF”£[ã›­ñÍÖøfküä‘=º5¾Ù‡ßø•‡5~úÖøfk|³5¾Ù?­ Ϻ7akü´f‡5¾Ùßl§%¾‘Î-ñ uzYWÓßl‘_Ê´Ê7ûçݘ…0-óÍ–ùfËüò^–ùfËüò´Uñ ;¶Ì/߸ÕÝ›°e~ùƬéã…-ó<Äk¹;aë¸~³¯ÛYÎ;Ng üƒk ¯¹öá7ª7ûº\%ð›}®…?¸~³¯ÃUÃÍÍî÷Uרj¤¹`éûÆp‰æfwN†B±;§a¤Ø‘ºŠ9{hÐ9Ó•özÓ•7§Þ^%ð›9õ{¥+oN½½Jà‡/t{ÉÞr®­ìÐ9µéÊÁ©µWéûæœÍIWŽœMéûfŸÍûEW·þ.}¾­7Ò™æÖߥï›óyãtš›—¾ovs·Ù§¹Òw™0gÛsø’÷¡KŸþ<‡/yßìÃåT”…£p«ªåSÜèkY6úù¸&›}r‡5>|r ‹·}â³;¬ñé³áá¿9gcÏüÞ"_iÞ"·Ðr/mµf‘»39]Ïa­YãÄ[³ÆÝZ³Æ=’µf‘{(i ‘¿ýÜpµöÎÅjˆü½‡Èß=*• T.c æN¾££ŽÊßÍGïþ}îtGåïî³ëÈüvëÌü<—¾#óÛï1#ó·MÞÖ‘¹Œ-™¿s12ßOÕ@懟ø›«;÷ÿÌèüˆÎ:¿çu3:?"ÎeTÁèü°9Óʽ»m¨ü·\ëÎuÇat.#©x¢óû4Íè¼Mo"ôf£céÐ4Voºã6zÏ5ºîŒÐ{nÞDèºg0Bï=Í!ô>ò9B—T¼zÏÕZýa”Þó`.”ÞóÜ–ó{7—¯£ôÞó1W·gÐY(=g»üóHu!t).ßùˆ2¿^ª³çûRZx':ß—ö,ÇùI|°ëa‚Ëq~î̉Î[„{–ç|s¾ÐeÞ %äðè|cùÍ/T¾LÇö±/D®.·ù9· ‘ïs¿Êm.[FäͶP»Êm¾¯Ušã6DÔò°Ä¹Î²>Å™zd$‰}ö]¶‚تꚎœKÝ5Š}ú]s–8_çÎ ›]“„ØÏT×°/¶jú‹‡DO*ŒÈ‡{ß¹ñŠû«µ™Oéì´Äû‰ÏüZÃæKæ¢þF⊣ÀåPÜö\¾__?ÓÚ»ü‰ÃÃY£ðÓ3ÇýàV_lßW¸~}ytêïò&Žøfý]Bh1QnV_nK×NSŽ8ß?Ê([.‘ß“=BèŹtG‰¼©Y˜¯û™¹±šËLu3êMS+pi¼É×…Ëhò¼áRùóûVþÄsüº”-cÿÕ9æpɼé’ÂåQܦL>/™·L„÷¨W½QØ.™·˜ҫУÍ\<Ï“]C.¾GˆÛSä^Ù èZÄ,{Gæzø`džŸwT~åì:2?÷çÈ\ö5ŒÌÏÝ2?=U܃h5§qæpzo¬æÎ}vè\³b=^Åîí°p=”w=nÕ\¾Î5¬Á|Ý&Ï4ïáó>yš³ÿrÏ ºOgXé63ú°Ò=5ôÁ'ƒÞÌÕóÖ§•žÇr¢t0Ò}E;¥¿"µi¥ÛÆ­o1Kn´Òós+=Ú´Ò=‚ÞVMI¯eT˜(=#l_(}‰å ÞÆŒ›[(=×~!ô™u!tÅ~a„¾"ì…ÐTè _9™U®ó=Ìæç%ô{dËáËu®Á.¡ßO§–ëÜ5-À%ô»/ù¼P¦±š›žúYÏY\Bï[™’àý¯+·â,¡x¨ý¬‹54ÌÃ:ûsöF8B>KècazàĹóW }Ä‚¼{¡Ó¿?÷ƒ£ó;¬x³º3´\—Òïöóýr ‡‚pIiÄQ»Ÿ»ºz‰YwEÆÜ,\WëŒPåñ‹=dyÊ/Ýb>rGÅF†Æ—K÷‡<:±•;ä’½ôüåóº·Ãn奅îhèÛ^¿»UßÏÜ~+¶šëâÇ«œ‹®0\±¼’×£•!/¤˜«q_6Ú3•sÑm± 9B_º{Hª¾hhƒKç=†Á²®š±Úûèå[ÜÂÌáйVtàò-n¡úðr–_zúÂå[t…jàj]ò6VW2Yo/ÝX„0äcˆ­Ûû’£s qåZŒxøã°ÎsúGù÷Êïºâpù#.øh=ñŠ{ÀFx¶dFãü=$I¬§ÇˆîÒ»V®ÅýÔæë%óØàr-º‚~02U62ïû÷èÀqÓa9£#sE›aî­‚ô02å^vN?Á—! iÌËŪk›Õ¾V½d~Äù˜ñ\#!\2oxaÆsOCC] Èn}0œ7×t¡p+ìñF:c|œ%ô»sîÌY.ôsqÏzÓª \.tS8Fè `Ü\ívŠÇ‰Òø»¥PÝÑÊ+ŒÒ3HœåCï;/kT˜³«c+´!s…"áò¡[âdãBæ¯ÌEWùÐ-QÁ[†ÕX ‘ûñ©¾$¢J°¤%6|£ºrìS e¦9|èxGC±}±«) ¢lH~?&.¦;S‘Z±]¿©ó*æxSžÁ‡M:_ÄŠÔ 7ZL¬(€¦àœ±¢Ø9Sñ¿b#¡¢XÄóm÷ÂCÒýŒÒÚæ¸n-»5ùxÅ>¼tÅF¼‹Ëãç$¯áqã]èŽÃDŠ´ n®Îœž×§Ì+±§“yؽ(²‰88FÂD–ÕdI@ Fš²j¦buâœ:+E‡,×bÙ™^Ñ ŒkᡯjÙËšôÄ~ܦÛŽòÌF”HcL”H8L”ÈóTœOh³ÿæêÊÃ(|ÑòÀ55[»'šêdÜZGà+ï|åx+N#ð(ÐöÒ•³";—}#ð3RGE#)ÙóFn”§¡Ù¸’0`žû@"‘bë ŽÇ8É#ª$}Ûœ¤ …ÁÑw>·Àm]MÀÅ>YÒˆ>ØßßGàûyüòÈ8É#zÚŸ(üòÀ:É#z¨‰Æ•AûyËáùÈüù:"ßÝ'èÐ #òçôì?g´ðPãΑEt(.£rå£ÀÈ<Þ÷\ÈÜñ$‰èÈZê\ǃL»íRyÓð ã<Ç¡»íïš’§™$µ,p̳dÞr)˜oßÎySd v”(³ÀY"o Á8Ï àVl¡I QË‚Á, ïév’Atùµ?Ï•"ƒ¨íã*‘ïé|’AÔ²€0uÃ^šþóy9ÏÛºÍmÛBî-)D;Ð0¯’y“u×xv›†ù¼dÞZž2¬YÛÆj.×$…¨)%^ZÇÛøY¤5ùàp©¼Éþ… á)箯w‹ ¢¦4¸TÞª]d5åìÁ¥ò¦`\NE‹Ó±^ÄC5c˜«;3Í¿‰Åã[¤}0Q¢çûD‰¦•»ÞD‰öñ±Õ<üÞDk¾W‹ ¢¦ŒBO w‘AôÁè|3Dµ&}/H!ºÙ'{8J”“#‰¨ÉZ‡º"_0N…Ö`”®H˜™îXêK3dqÚÇ«x©O"‹D"ù… JŸž,X jÊ 1~½xäµ„é ‡M® ŒS¡8!ŒÐå Á©yX<7ò°GÀÅG“cVLQ“ã#tMJð7¡;Vž#r¶Áئ˜*l{t^7*¦ £s¹0:?¹ž{TYju±X§ñú‘‘çÖ(Ü#öµÁ÷¯Õ=™'ð±SVZè|y Yd5 ¼0:·ù¶H"j§Ã&÷lP­]¹TdµLF‰Vº+dµ$h-=‹rô=b-Òˆv0s©â 1¤õø$·!§Ã÷WF,òˆºFØÁÐ äuG÷Ö$úvto‘FÔM\ZRÜ"a ·]š±ZËòñ"¨ÇßZ‹Xh\×EQÏJÞ=SVsZZ€Kå= ¸ŽäJ>Æb…'àRùŽö-²ˆú~*ÎRy–w©D}?Sg‰¼ËT2WožÏKæÏÏ =G/•÷ýŒ‘JôœÝéQ®mÍE=«ÁK– 8©D=Q%SKlïr‘JÔ[”r"Šu½H%ê™ÊåÎbÕ"—¨'Ó`]DBåÁDBg^R¨8H ÔãÅ©ü+¡uq’Lt3G;¸*Î÷‰„*-FæoÇ]O’‰j9FæÉ«Ðzcl¾n•ÛÌ8É&êJ«ò÷t’M¤õ¾Â7*×úL$TžŒÊýÌž$í+ê¬Å¾6'ÉD7s'O]C±¯¹DµÜ#rÅ/ÍÕ™ØH·ãWͶN’‰zl¬SiCbßø“d¢®¬™+ ó±ËyfíÆŸd=×J¶Ÿ8·Šl¢®éFæ¹³$uÍÎ0G÷|’KôœŒ.b¬N.Q-¥ÂQ¹Ï†d¢žxÒI2Ñ~*N²‰jíFæÍA““l¢žµÿ“l¢.×.Ç¢'…ä$›¨g%Ë˾T$ݘ˯Øû“d¢›Ý9’‰ß?É%z0áþ°ìë¬V¾g0¼'?Ÿ£ñ}¸È{DM*Ñ^ÖboA——jd°Ë…ˆ\m‘k» ŒÈµ £rù…0*×J£¹º£ 0*_ ѱžYøœ¨É‰å8¶ÈV)|Ȇ2WsʃKáC+]p)|Œ<Ÿ ˆ=GŸ¤ÅÖ:y)&îë`rÏ¡Rø{ —‡ÌM¸>ö]"h$Frž%ñqe,#(ûQ*ðhTëSÃ1\Ÿ áòœgò†Î³$’ETA'¸>cLœ¤ÍdoW)|f…è$hjÝ .…g¥ñ$‹hjå.W ®sÕcb¬ÖöóCÑÔö2¸ô=s[/²ˆ¦zàÒ÷L×EÑLž­:3ŽòEÑÌ$qûáÕ\ÆÕ‹,¢™qøR2¨ØçEQÅ1áÒøÌŒz‘F4•Ø —Èg’W.òˆ>¸T>µ ׬‹ýz—ȧ–$á:› D3«1÷hAk6¿Ùû6ð¼#ÒÉpí„Q¸öEÀ(\±F…kò€Qø¾XõkMd ŸQ¼Âb[QéCä…Qø)éCsxιfI|ÏiùCd†ÈÕ ¸D>åYÃ ä ”]äMe+/†ò žl œÊé22’Kå3ËÉ×b ×rŒÌȺ´à ÞGGæZH:mð^x36×BçñU.<«{¸ðÅ9ѹ¶ Âè<;!®³tþ<…˜ÈC\:Úû—·B£pé¼VaˆöC¯ºú}˜Ã¥÷gÉüžôtÀäÉÉ€…™i‹ë1Ú‡#MŽ<51.…rA`Òäp‡ÄøòzàÒù ž+®£1-„¤ LWq©|àÛ‰íSÔø,.•|I±}Š|\çÆ*GaõÅ=!whÜÛŸHS¥ñ,Æ^Ql1¹Cƒ@¶,³¶°ÚÂýc±ìëDêÐÐr"\¯œ¸4>ˆò‹KãŸãœ±* .âòâÒø`‰E\"×Q I³¦qi¼2Œ`0¢ÑÊJ±['uè¹ËZLøòóÒøÐ6˜¡HLŽ\/,G%çá<€‰+èZLâPeìÀ–xDEâÐWÛ˜ŒäIšlv3–WØKXŸÚJ3”“Š#.‰Oö‰ÊIË3–fl]É#$2‡jf$ÇÁ—Ƨâ 0#9Æ®¸4>Y^×Ù)N`¬Îl¡)#µ¾î[EâÐÜ£ßÉX®è>Œ¡\´â‹±§“(3‰ROÄeK‹Ësžû±Òú€¸L0qyÎSQ˜Á7_üíçŒå¬DŠ1bòkv­{ãiZ™pâ·öÊ=À¼=i9®ÆÙRXÑÊ5ÌX~zð}3¢L™°­_8ož›Évcqé|‘ÛY¬Þ,vŠKé+sÁ›Þ¯w™@7k„Øí›ä¡…¿'.¥/eýÀß>.¡ü¼œçÅš»¸”¾2U½ÉZªØ—Òky.Ïâ9ý2WþcaõÆwú­¬ûO,ÇbeV~k­Eì§øMöЊðVXªN6¿/Ï¢Vcáú’ —g±n‹Kèʹ˱Xì:—ÎWtÉ•ËöÖNÀ—V‘|²ä-ÕIKåKiwp9‹6q©üÔý†kz8Y…ëç'Öc¡úr’ .•ŸX‡âzÈ+4jÖé,ÁüןީüÿûÍOñ’™£ƒÜŠ?~üåëÇÿ¸­ÊÏ¢?ªa¿XVçÿ7EtÕÅ5ðp™ð\ÿûzû\6ü×ÀÿÁeÃp ü\6ü'»;æ]ô'\#ÿ— ÿÁ5òpÙðüíëeÄpü\Vü×ÈÿÁeá<¼‹þ„¿ã×Þì¢?áø?¸,œ®ÿƒËÂùä¯bØEÂ5ôpY8ï¢?áoZ¯çÿ¿6GÆÎ“:;üMêdì|ð·Ã}“ú.úWå…/©‡#õp¤þöõH]£¡8RGêáå߇#õp¤¾ÙÝ1“±óÁ‘:îðAÆÎGêáH=üíë‘z8RGêáH=©›Sôgówto4üŠ#õp¤ŽÔÑz8Rßìî„#õp¤ŽÔÍ©ýã°ÕAÎÎG7.+ç½K ¥öÏæ²r>8R—•óÁœ}Ž^6΃ºqþ1ZæÁ²o´È7Ò 5,ãæA+ÙM™ÉÔù`ëÛ±´ƒL¶¾7[ßí‚?Ý\Øúv¬ê U热ïÍÖ·ãš»âÏæïèÞ„­ïÍÖ÷fëÛó]ógsŽ¿ÙÝ [ß›­ïÍÖw8E6[ß^´IÑŸÝ\Øúö*ÊA¶Î[ß^ì;ÈÖù`ë;ÈÉo2Z äê¼wÁ#ru>Ø ÷"Œëþ|°5þ0qÈú Yçƒ-óÍÖùæEgÅ=ÈÖù`~ãW&[ç½ $‘­óÁeŰ…î¶ ÿ|°ÏΗžl÷®D¶Î—ãKGªÎS)eo$ëìHlKß%¹:»ÆQ%6áRù®yÔ´ƒ¯˜SoäêìGMuh¾².Ý®yÔ^%”9jäêïS¶ŒÐwsdìÙîjáz!¸òŒ?;ƒû¹ûJºÎ‘ô †÷y$ݸ‘¯s$¹¹á}îIÂΡgFæI6l$ìÙÙð>l”k$ì< ð>¬ªè‚0ºÀù<4ÎÀÈ<åfÎç#óý}œÏçxäì²T`·îÎ’²s$1³‘‘pdU#e§j~–ybrvžÞ³°üÔ³"içH*fcíô¹z$íÙ=ÓYÎçAXŒÎµ_®‹¡Õvc]¼l¿ë8Ÿ‡âò0J÷Üñ=ÝR˜{Û¾{»È.4AÅÙ–¬œÊl~É>psŽm:i¸”žÀ•‘*´gR9ìb`LOEïQ¸„þQ¨„Þv™ ÊÎ6í-ön‘¤²uÊÎ~÷¡õ«•Ðeq ½©|\Bo14:®gY~°÷æzÐ鸞Gòð*ã^×Þ£HÇùÜ›N«€EÝ;·ûyh«ŒÐµ‚#ô¤Ÿx²Ô¸l¬æ’ÒµÈ#ηÑ9Ë`btž¤§J™{PêdˆëèÙ.ÒÉÜy>¦êìósRwVíÄè\5w`ö.:e¡StöH&k'uçØåj¨:û<¤îÚ£sqÌòÝ`t¾¢$.|£èl¹f0ã¹¶ ÂŒçZ{ƒÏ3bPuvoîx ‡váÃõk•¬1Z¾RT}Š6á€îm–ª³{ËyÇm±¦;Ug›–w`TžG’ª³U FåÞ;Ug÷è‰ÿÙ’2Ù):Ûöx…ÿyÏŒù¼DÞ²ºã‚¶ýPt¶ïÅÛEö3IÝÙzôáy=+p}Ì ]¡šëɤ픞íZu…I¤ÏÆíNéÙd0woÉ`JáÙǃä´ë¸Sxvìÿs( &˘%*1Éiìž±®;þç®ÎÒ©<Ûwõ/oÉùNéÙ*v—ÈwÝž*Ãò’€r~¥ò®mÇâúrº>¼[dWÍ¡ôlßE"¼[$IEƒÒ³5Á$Ò§@jՌѶ¹Jæ^KŠå`½%÷n°[ä©–ÂRq“`Æòèh°ZõaTn[|°ÜW–ŒÊ=4Ö´šâ 0"O:WUv{|Þ.’ê­ÃÛE¬ªáÝ"©:¼[$›S†w‹(³Ø»Eb¼ïÉ&§áÝ"(àúX©ÆjN5²`D®²0"÷€1¼Yä) d‘Û‚©ú—nx¾Ês£Ù-RE¡Š½[ä©ñÃn‘LsûEdeÂìÙ_/‘÷ÌbÛE4êÁˆ\¹–0"ÏŽ­áÍ"»–Š7‹d3Ëðfå‹ëdâÌ̱–ƒÝ"Ù™R¤¢ô•Í"ÙÈ2˜Rå÷H|—Щi£Årԭʽ°ÍOÀµ{à%k'‡³¹âiePw¶%%zà~ÆN”}*¡à~VäFã»V“ëíJ(”Ýt\'Ara[FÃ5f¿ªôÍ:žÔ†«Î&´Xé4b»L#µBò€ºêl}ìû*ƒÂXS¬2a—ZðÐ;\u6ƒUJkŽ;¶â]s6Ùä#}´­²mßs? Þƒ`ÛÀ÷ÜWÎÛŒ¸ž-!šÁf‘ ÁÁ¥ð– É`³È®E0ð>[¢"ƒÍ"MeÏàRøÃ-#Îgc5_ŒÂS•pà|Vip‰g,Á÷| â¸æì.xcã#O›KÎîaݾ§Ö7áÒø¶q‡}Ïì ®:«@3Œï›w¸ì¬¬ çs.;›KÃΧŠGÀ”ðÈàaßSAw¸ÎV7ÐHkžP‡«ÎÊ‚m‘»õ骳»r‹]Ï”øªtc±ï$‰l~þjëBuÝèÊ&~Ú§KÎ&³~Úï´F+å²SŸì92V†hqƵð]ìš³2§`ìq%xÁ5ç*a c‡è·8Ù*rq"¦’ˆñaLÜ]4Æ5g•ó cŽïëÊV‘§f 7Íwa²UäÐc—Â÷]›8[“­"G¦ÏÚ#NgØ+r³ÏÖ?·õ_ÛwŠós$®ú™0× #ñTïìQ¦,h…ç²]äÈ”3ñ:R‘ÄVøþÜ ÷40Ù/òÑœ¯VNèŒÒ5Œ–¸/Ž+Îî‹§3¥M\q6àŒÓéõªéŠ³Ê·‡‘Md•гùÔ"w¼¹RÆÅö+E\ìácºàì.Ic§s—˜qÅYΰGrO•É'ö”<íu&ocºâ¬gèi§3<™¡GÖæj«D±ÏÞgFæY«›)8kxÚë|Ì3¶ú×<Ø/rda²_ä9wö‹ìÚÀ“ý"Ù|6Ù.ò ÇñÜGv‹|͹ý¶Én‘=_Ov‹<çÎn‘õ&›E¶9àr{Y®šlÙE¤§«ÍÆë›ìÙ¥t§k[Ä–™ìÙ“Xí?ªIÏgeµ«÷ØéŒjØ,Ҳ׬6ôˆ£ 6‹Ô #àÒxKÿÉf‘–-Ô=ª7:kV/¸DÞ°œìÙµ'>gKiõÉ^‘¦ôr¸DÞ²3~²Ydò¸-ñd³HKHqâv¶l¥lÙuH&ngËfT⻪ÉÄëlZ¦‡]H$ ^ç.!S»­Ä9]¼Î]óe²[¤%4SKPj±U$…NgK\f±S¤ep[8-ó÷b§HSR4ŒEž‰f±Wd{+^§O…½"-“äŠÓé+³Ø+Ò(¶Ó©Êùpµ–ÑiÙ锣òï«ôP±§¹Å^‘#wñ“ ˆÃµhÛòLR1«e@Xliy„9”- Å^‘]å„4«–-M‹­"¾‡Qyª™-öŠ<5TH•i‰C-öŠ4åhÃÈRwwá}Ž]އWžì’X8Ÿ#¡"÷.UÕ¾çØRæ•'=AÂ…ï¹Ãn‹Wžt•„‘z¤ÄOzÞòá:I».o<é™v¾g-|À(}—˜À÷Üq±“7žÔ+`+Ý#ÚÉOvÕô÷³kä‚Qºgí÷³Ö¬`„ž°Û‰ÿùÔx©;ßwÝÜÏž Å'¯‚ûùYÞ‡aà~îjb©=–ûŒ÷¹ßBqò¾“žý'Þg×V ÙÆº=w\ß‹÷ô˜8~IEbc'ï;éyÝʉûÙSùä}'=݉ûÙã¼ïddü‰û9²¨qò¾“‘2u'h½f4G8 õΘÑR™' r­S± BNÅ‚Œç©X`³àJÅ{6—+¸ó®Wº\Á®8Uaï™Øëåréš«dáèr¹‚ÄV/PÞ\õV‘jLÌHžò¼e²²SÈQ>–د¡Xl×ɉÑ8C»“… +bLvuˆëe ¾ÐœÃc³ð.é·ªþÔK^ˆ›…¤1g=CŒÆYl)¦;åYˆÑ8ÁR1/ãRˆÄyBÅH\6!ŒÈYÒûÎøbà€rãÞ*úÃ["£ñ]0…j˜šBKܧF­Ï2bžß"p©Äœ2ãbÎ.1'BŒÀYÖ~«ÄDi²¸º‚q)FàT²#ð2Î„è› Éb®´e‰ó&1æGn3îg-nÃhœÔ 1ßÕ—”Õ-ÎÕ Yü)`ÄÛNFJ'`û¹JX¡:3x!‡{…43qÍšC D0öÊ~†xÙÉ`àãÃÝP¬îìj+~-!o=×þQõ§Z{ÊøÔ²V™É¢R8%H…D ÍWS»ÚΧCbj+1p‰ñî($(.…ã* I܇ç蹎v=ŸËbûPÏRlß3çRße`^v>S&æ¥h‡Ø¿¶»Erqi¼^{—Êobóq…ÕÞ™˜¢3hSt&×]yÂ<Zzû:iXî“áà™C´‘ô¥…+óšÍµ ©ÈM{0zóšÍÅR‹¸V´aIq‰|ñ-®ö´‚Kå‹XžדP¡¸T¾¨/Æ&'•[\*_œ|«ÀOµGÕâj—…ˆ1Êy“‰¸T¾R©ïïYoO€Kå‹:ÇbŒr½u æçÚ߸žäZ Kä‹òšbLrÌ1a¬Ü·*üК•ñæM›‹3âjœ5»Âê ©abTÎ[¸Ä¨<3øד×ã Q9‹¡bTžçÍ‹6k‰.™Ÿ¤Ý‰Kægʾq=Ï<5o^´y’;*®ÓWnXŸ²ªP­U4.™Ÿ)MÇÙzT–§*ôðÇï~s[/‰ó?ýÅ_þpuehóó}s«Clª#hÓåóñäó–: þÂ'óÎþÄýOæƒÄ‰ýOæU-êãŸÌ7N|êýOæsÍþÆ'W=£”)Û×â“9†lå?ü_WmóŸX×-ûýý óÇ7¼ÿí¹rNJ|¾á|ðçºÀßpžÔþFò¦žoxéð¹rðÇ7G{®¼¿ñ–¥ùñÍßxT³5´?ýg]·*±¡üç-UÎ\vË_ÿö§÷ëŸþ퟿~¼üúoºÿï?ýô¯^ÿú×ÿó§ÿëŸþó/à “ø—pü‰Ô£ôË?ïâçd ½åàýìïçŸøýt’_<óO`aÉýòÞêž.ñËGøã×ð-ïîà_EXô"¾¿]Å2Fù}ìÒo«æ]Žðþ<Â?üø‡ð; ¿âËIüø‹¿ùoùå•1ôõKÃ@ͳ¿ðXø³Ö˜,Ûýúñoüoý‡7u>ºÂ´?{.ÿñ~ÿ7ÿð/÷ûÿýåtþè ”YÿûßÖþå']¯7…ÜôOM¤ø0bèO—5¨ ìçX³ßß~^šÿ—üËÏÌX?'ÍŒ@ÚÀ÷³×é÷ÿëwÿýýgöç¿þz¡'—\ÝÛ$©!Ïos%Yö—†¬4ª:?Ûè¯ÿî·óãŸ~÷ÿôW¿ù«ßÿÝ?þã™wúÅ¿X+/'¦EˆÏcQâ¿þôîƒT½ endstream endobj 118 0 obj << /Length 1347 /Filter /FlateDecode >> stream xÚWK“Û6 ¾çWø(ÏÄ ©·Žé>2ÛéLÓ¬ÛKÓ-Ñ6»’¨’Tœí¯/@P޵q¦{" ž(¶:¬ØêÃÖŸ¶oÞÝ—ùªŽë")VÛýŠó"Nyµ*j×i²Ú¶«?£íQ®ÿÚþüîž×—¢e\Ôèñ2n2;½½½½ß’èBkžÅ9+fQÕìåà„SzXo’„GGa‰´ S/jDG[ ”Ø©N¹gd$Q£ûQ±ë$ 8MëÁèihÃ!¸ |f­6Uó"]m8ë<'{@w3uÞ4¢¨#áUÑjXƒvDùϤŒ¤;B®y};Õ(”+Ù¥VÑûY9Ê>‡sýèf²“3zP í½ùñz“et?¸Ê¬m¼#léB¯| ÇølçÑdá/æìÛ—_ÄÐü«-mDwÐF¹c?o;½Nòè>c '§†Ã¥.XG²;¢å‚6j ÛÂö :+Í3íNª 6ÈÜáUtx¾æÃsr„ö™¨ S}f,iæß—“£¾+~Y¯iWŹ`÷;õWj5Éâ"©f)3u_:<«ã<©—†>ÀÕiÉ)¶i …9¥MÜ—•ŽÇ5$gTK"ûihð£è,}FÒ_qHLûLŠP•¼Ú—w/ Ù5’ŒGÿ^”½‘ÖA‹9âë[(§ÄÁb!ç]ÈÁ-£Vè’ŸYÎà‰è{4Ç:…¤RØpf/`‚oØT×µ ßÕÐtS;_®B ÷"Ú@G+-ÅÿÒƒâ"ø|O"+zI,;*ƒˆ\„–…Øo¡:ÊËê`gI>ç}Z§awµDÒ4fõ,y÷øñÓÝãã¯tÇhôßp ôƒ~L“â[1.À³&w^žyœ±r… °ú¿@#·F_QÇ:KÙNY³¬Zæû´†iÓµÔ„)¥—“Ä䤹ïv,WÌJ:÷z”QVO¦ Ç÷ã`AªŸHÉ^ú~.)u¦š?¶\(›\xpg¯ÖFÊs&<ʰ„¬#Ö ³Dº£p×Íâ$/_èsF.ÝP!Î8ºzot?ß'‰‘¢}¦M%H‚ЫÊ}0™ÇcCFyŲ́’Ç9¸ðx 9WWÒÒ¬ºZ²i§YúºŠM@yù}Éâ>]H@Gj3j#Üké…MM#>2O˜y)GÚÁôõòçó¾­a¥Ñƒ—ùþ†´gyþƒwŦdñ ¨úßÇEòíqáß)T†%dÚ[«[dþbä6´V…§DÝüñH„‘£¶Êi3 AßQ· Lsx†8bSmÐIB.Jq0p]˜â:•qŲWç5ý.¯oI·ƒH"OGM„Ÿ.ž€ÒTô×eä|cÑÙ ãäÌ ˜¼~¦uÄ]¹Ùg—_fQÌÀM9˱ӆÕês¿ÑÌ©ÁÉÍàÁržõˆ(4qd»ÍSbz(€”¤Ž«ª"SÞ7OƒÆÒ=u²= ñöJtÃÈIà)œp:øéa ÍðdgZq{÷ðøžÈˆ„6NM=íq^žN§u‘Gq+•±œpnâ( ðq–p5Â3öp|¡þîwZï?DøaÓ¸NøO–òœ§;¡~‘Е¦’8³&¿cðÄ®yÆñ2à9|°Óð¤0„Ì çïî«3ÒcØÜœ_‘WðýzQAñ tÐÓÎgðü—²âü”0¨&€»¸äᯄW ©»í›ÿ“så endstream endobj 121 0 obj << /Length 1281 /Filter /FlateDecode >> stream xÚ½XKsâF¾ó+t²QUÏô¼S•ƒã²SlvmR°§Ý=È ¼$¼"‰˜Í¯O’°†³rAÅ#ÁL?¾¯ÕýhôÑè·­>u®îŒŒ,± T4šFŒ*Â¥Œ”¥ÄrˆF“èS÷:Ù]¯Óåd¶{’Òî5)?‡×ïoãHÚíß>ŽÊË»þûÛaüeô®s;êüÝaèŒFlo\*tHU4^t>}¡Ñ|Q¢­ŽžwK7@¤’x=†?ŽD*%Ê”ö—ëMQ†p»MëyZÞ0ËÕnî×càèàpgÞØ8]eåÅú9V²K¶G’’ø p˜·æÕ¤<08M¬¦ÌKN¢lâÅxµ,²ÕÜ…€Ûz–%ÊŸÆÉ|¼™'Ålµ¬25 c\aÒ²Îô—=/+4¡ ê—±”Ý||èßš,GH¹Å9&,?­ÉZ‚à,¹’Ùùnoú¥.B8jíS}÷EQÅ€PV]ßõcÚ˲¿þÜääãà.ðܶO eE0Ζ2ÄÔ°†ýQÿá~X¶ÙQhØ×è4ØRõ‚dù”Õ`>°„óO½ˆ˜§€% »”s‡©ª=‰¶o%*h±PñO 5ØœÁqåU_²¶!uC˜¬Pÿ¹fe¤ }§ß-K¢–Î;Æ`-ªM÷Ü=†#;šiêÒÀ¶–SCeí ›™­ƒú=@>V“4»*V•<|†cNcá¬5µËÁCÿ~4 fL{êŸbÙM‹$d yáQ¿—ÎA)ÎnæoQâßÛ'y޳œQ;®Qêø!N9¤ì¶²f¹â#ÊÕµb“=d%¶ "epcS9aÜø¹zþ@”ÎÖÏuž,Çÿ®r² ä&,¢·Љ¥,¯³+’§ôõ£à,“TŸ÷¨ø€]Å}1ÏBîBá XTËÓN6N{8íè-•ò.¼.DO¢,‘VÑŽ\ëéÉÁ¡”/Ð^UØx¢‚µws^…]¾ŽxÓ”YtgØ9N Î”0ÕëÔÏA͇T¶gË<(“„TÊc䈲‘-ʇ Âç(WgJJ^)ùÆëˆfÁVQÏŠ4[$Áó \ØÖHq|u¹ºC°â™­Ë¾'Càù!*?¡™?a¯~<}˜À)mÅ)Ý©ÑU-NI”Í®i…,³‡Aüðx@ endstream endobj 125 0 obj << /Length 1021 /Filter /FlateDecode >> stream xÚÕWKâF¾ó+|Ê0R¦¦ª«Ÿ‡\íFÙ[n»{ Œg‚ر=ÚM~}ÊÆfhhˆ $RNæÑ®¯¾z~ÙK†Ù쟿OHž˜QFhÉ"èà²Åzòñ3fOòç‡ ÁÉO_º£ëŒ½c|^e¿L~ž|?›<¾÷& ¬²ÙìygÌå(›=e§?mÊ׿þAœ¾û:_—«|û…ï?Ï><¾wûC@„Ã7뽟‹jû¡(›e±™¯¶†(Dž°ÐQƒ¥æµúµhMÞÍöÈ3!:õwþ;û˜y„ÇÄ`­‹™¯æ›ÅŸE _LuXêÁ¿:_›§-«r^×Ç®îBë-â³¾äiHzçµ8á 8¤(_.€ò½×߬ª<É[¨»“ÚŸCWòâHŘ A…Ìe—iAÍ$Ag#áéþ,«ü¢¢è÷y0aÅïvq~;amÜý`ñîÛ-ŽjÆ[ ³ý»xmž–U &j ¬¶Ã‰Ç„ ävÄ•ÁQF¬¢ˆTyÝÌ«&‘&eÁʬ!@ï®ËSÒJL!xïû:mò2~|¤È{jÁå`Úq¹Ñ(ð|O8¯ê<•¥!xE5•Œœ;ßJ ¾Ioˆ)z·d24U±:ÕË&¯ÖóTsEÖatÀqÈ‹¤^“¨/Ëb•μF5ƒzNÆ-E4¿Í«{òÓ—> stream xÚµ\[“ë6r~?¿By²¦Ê‚qèdŽãÝÄ[®­ÄžÝ¤j½‰3ÊDÉuæÌüút EH%QÚ' ˆÆ¥¿¾¡!:y™ÐÉ|¢á÷‡ÇOßýɪIF2Íõäñy¨&B©‰Î(ÉŸ<.&Ÿ~~àjºÙÕ¢üú0S”N þ÷§¿ü×_f\ÑéߘPÓÏ¿üôù‡ŸÿøëÃ?ÿÜ‘ùãã§ß?1(Ò ÛSP†˜ÌLæ«Oÿ,àåŸ'”ˆÌNÞ\ÓÕ„gÄh(-'¿~úïƒ.”’-Ñv° :á’š…>Ü„M4aƉl¢¥ Rùùþ{^/Üâ E2¦GPíõ!9¡™¸dòRpb3žš>tÂáÍe0èÓ³×f/Ýì¹b~ú°“ŒMóºÌŸ–…ßÜ*_Ç+Â'R²{ „kI2›Á@2ÂyæòcñüÀè4ß-$>DI=™1F2¥¢±.w‰á jˆ`òÓÌK['jy;¼í¼.7M¹®Ž‰+#‰±úzâ ¤@ÒÚ["­!R¨áQ0© xè¤ë§ J*¢Ç.~ÿ„/f¾Åš¶ñ¬m=ë5OH™ƒ>Ýr.ëæ‘œ»†Ö÷vr ÿÐþÆ4…$’Ð,«Í®iÉÌ8ZS@ô –@=GtwÕ¶hP1–ì1*”»ò*„”}TàãÛkQ»7*¨¨s4oËña¯L°u¹\úÒShûXiŠÊ÷àUÔ¢ŠB­”ñé/ðtÝ´õËShØã`×AøÁrsæû{xÙ‘tc탈•>ÄÒ×.n‚¥¡ 5ÜÅ<-48‰ü.< –!<{ȇµ>ÍÔ£[1µ%Tñ˜0yΗÛ9`íQÄÓ¬ â0ƒÝpÄÿçÕñl=" ¹ÂI>ùþcX|¥÷’¯©wû RM UmÓo“™PnÚÍ®~Z'fže°I†Ë ƒáºJ²ØíˆéI Hm<õe^Í?ÖÛ¤2y‘íra‘rÏj³_(WYw(…Êçz½ m}˜`ºùR®w[‡]°úafŠÅ.«¦¨ëÝÆ›JСó <[@üUt[$5\ÆÀcï¶ç$+Kð¿¬n‚ùqao[Sî,ì3öE¡¯`ö›³öì\Ú€9±!¡s-Û'„ŽðîßmB4?“â.B‡3À‡9³S C}ëŒú–Œ{°Sak‰•&&ÜnÔ Qwût¹fDS-ÇWù×17ŠpZÌqC´U} ®,˜¯‹PBMèT³²}÷=@xðØu^hý”?ÇÀæ¿zÊ®•–µò6èµTÅS<½Œ˜y¸þN¢ Û žJÏÀ8œ8Z^ZiC•AZ•ïšõ*w†þò=aY8oÁù¤Á)Z#}ýœ^Eè\Ëþ8Ÿî.xP{=ô³á­ù_l¶C²äZÞJȦ”·ÉŒZ!ï!KdfÜw§cw*#J×P Ǻϊ ÎO¦bš_ ÐÝÛ²y?-KÆM÷À¿’ÖĤÙi)2šdBŠPA„Ñ­qɶF¡ðRÔ¾¢¯Ó°F8G¹^/ÃPÈWà°6¾ XpMËêy]¯0ý‹=–-ÿ H­x*â¿Ý5³”+°Ù5¸zeŽ1€]èá0öB8;áBßNTœÏ¸ØÌb X…Ó%à+¥íÙpºo=ë5O…Óã>Âé(¤kh´¹-œ®`v4ß=0;]/ƒêGóŽV–É`ž€Ë®ZØ^(g`2¢µÉ#°.0mĺ<é(ѹ:ŽªŸØ°´ 5ÖuØ@é¤)cüŠa¥Äô6]DYQ: ÐFS=–hÕ¿ìVON„yÍì~÷FB%xjcÊEâªX É™«œ4Ø7*[®AkQú„"¿@ÛÂ/gÁ{,7{|%ØdÙ´Öë“Òz£i&˜Dk®A¥|F]¬ô=TzÎÞk-¿EP*«6*ÕÆ~Ñ\«¢jb®ë,ÅÅ{•¯B¹m½ ùS¹Lê;´=fBØÖI‡’ ¯ ´õW  ‹Å÷3iµ_ºïþ~è~¾Džì¢¾ÿâ[dYd™–uço”‰.:¢ ‘ÑmA¬-%Fu¤@È™ýÀû¦­é”'æÉ`„ìöy ¹Žæùþž™ñv§)ÚÄ}¬¶X$æ †gêŸ0×äÑùgl'Æ€l#t0Ùûžà þ Éiæ[Œ@ÕEá«ön<Ì_Ãña!T …mñû YwÎð½”-«Pð8…Âóñ†¥Dƒ'pR°e·ë 4òÖìŸ?ÁËM°~1òµ.º£³^ˆ $ëí™NbKe]›yÙ ™.$ÞŠ„!ÕuµM¨.èCf·ú‰”ƒü¿ŸèüÖÑSQ]£ÈFÛÀÁëÔÂ%ìd\·ŠËëÖÈc8D ºœú·ÄBuwB*ÿÕBxüE<'NŒ¸Šƒ½g«?$q‰y-Áõ{ûºuÚ·¿p?FŠ´ ª#ÛM?Š&÷¥4ˆ0Î"”½F-íµÿmMÁ6FícÖ̧_`! â¥Ü‡ÏªXŸÏBt § œ‹‹Nø7? Øk>Wè‚Yu^ÖÔè{àU ò–M¾Z-NãuÙä±TŸìE§Rãh'y^€|×ÌôO¥¸¡þTŠëìÄ©%JðËN¥@$É®©tûø`A=¬V³AG®ˆQ —YÂV8Ì>u ßlêõײ ç5‚Éì¶(X¦ÎúF ,^½„y¾¶qW&ñs¹Þ};·Ì‡qõ®=çñYq- $;—0HÛ€îYD(à8œ j}:Ò‰ •÷ˆtF4_¿Î08n¦iö©^†ÂqÔÓ0Ä´ šõa(ó0”ŠŸ€¡$ÖŠ‹`ˆl·ÇŠƒ!öFiõRxe ^ú`k]¡CˆÕxJQ`¾Bcû?óºq¦.¾uÖ%¾q#øêû ºy::Ș¯k—WXE›Ý áð*4~©ÖµKþÃÊÊWúL¨èТ[’Q<üÙ-=”û_äUû¼(0ß™¥øáySûÌåC“9#C`¿zóh‡>4»ñˆã±JÚû 3BmàBØÃú¥H‘R"oÌmvÛ©W>]ØÍ ˆçœû‘SNFy"Ò¡Àñ4`‚Ð6ÊÀn²vãt®ûE·[‰§‡þÕ—œCµ ´ ºµsOhF¯qK1Dí oì á‘ÜËü £6 µ=¯u¡ñhɰö5y+ðÓ¿ôg*¾¾‹Fé€éƒ‘Œ‰BY©J«‰à¿Y®g¼ ŒYð}.áȳg¼ sEó¾)Òù6™0û¤ÄY’ï×¢q‚(1Lŧç |p eBdDRä;P â¶4”3ðöÅÚ<Ù>ÌŽ³p:7¤B?r•ÿæµµÑÅ.–°îŠj^œ.Îí"wâ³ýmÅ =¿lDÆŽŽmz[KAt£Øí/Ãf½mÒ›Ët§/Wxèòõ`®ÞõB"¡ !ímç|¦š©[ŽùЮcü‚+”§nÍ(ð-9ÚþÞ»;sk[ÏzÍÓ·fú}Þš½ÅvgÓ=Î_šü€dË.‡wfæ{pgFhf8MÊ^³ Ñ…%åÄ*—Ë2öÎŒ‘b¢aJ¼3“ܧ¤%Á3êÄ—¿ °*^Nksö„•·ÞЊÅD)Ðæciëržâl”°lhOãŠCümÚ×}=ŒÏÆg›8ȃÏþŽi/œ¸Rã‡ÎáÅgÌÜwý†®ÐL/“fî/ï‹§ÐÖKè]U6[gŠŸ”n×.Ú±lô¼16Á̵‡²i6500œ¾b³-´#é¦9µOw˜SGSMðjŸêc«›Ÿêu ØY-q†‚É"oÎôX˜éâ4‹|µñ!Ôþ`úùRàCW>ÍyŠõúUH0ôÁ˜½‘ù Uâ.Þ—˜´Ñ^¬Áò±63À0flj†6ÎúZÀz ŒúˆêK¾Z¥ÈfðP÷ Ë)ø:FÆd?(£Ö]º¿I†lSߥQ.Ð4„á¸Ãâ6ÿUh€Ó®¯öLáÊ…EèNd-0²PÙÔ儦½I¼õÉlDÒܤ—pN åw!.¥Å(.Yf©ÉøÈjy>ZæôµJébéû¼êq`U.^¤mÍ1Œa®û[9gkÙLø˜® ì¶!ÀG†ËíPžìõr0¡çÁ´êÆ$‚ÙÈ»$pfö¡ý·Ô ú™ÆµÃ´›[t¼2@RÅ$$AH.îBRk Éb’Õ`¦Ã¸µMFo#ª9z£I&Ô+Fñ¬>ÈãÖvA/ømOÚÃ9$Ôt§é[ÿŒ§å¢pGþR¶ÿ ÷±U|wÍÝJã™þÔø7`©›ÚÁ¼÷'¹>Ÿ4~ëŽïh›¼‘ÒÎ|i°K먎€ý!Çé’Wç8Éö ÓDþ Sî…r·Ýº[!UöP¸\8[…ÌÚÉ©s“]Ãìê·r[ I¬k9+!°  %oÌ‚pç°\Ý%á–Y¶?ŸH‡Ü[Ç›ryÇ$¢ÚÆÜÓdäd“"$"; BÆÓ<–!,³˜ï¸Oóôàn‹ â Í›ø4_|×Oóõo ÿ¢=}ÁJw‚ºðrLƒåð‡þԴߨœJˆ•.T…2¨ s<ÌS†¿TM?û·-5,÷©á³—™Á„]|~øÊ—º\´ß­ëEYåî +|c¿w”œÌQÆÁ-É6kÿ-Ë=:qµ,£ý™ù þnêõb7w‚žø÷þÀù1ùÍ>è×ïa§(sb31Îÿ×ïÛE›©Õî –Å÷þ r¬ÙTA^<’ÓÎÛm·eÞf}îZÙŸu×#àXÖa‚ëÛN7˜Â{ÍWü}^ôŸ±zA"“n|†ÛÖbÂä¤.¹þÂÂ6üäþ2ë(Û­_RÑáQ’=wë^ø„Hǹ©uŒÞäañœ¢[÷Ý‚þÈH@µ ©Íþ‘[艳Ã?8ü΄¦ endstream endobj 132 0 obj << /Length 3652 /Filter /FlateDecode >> stream xÚÝ[[“£6~Ÿ_á}\ÛVëJj·j.Édr«ìtgS[“yÀ¶ºM­ àôôüú=–±Mw^ö â£ó›d<¹ŸàÉ»øÄõ®xB&GHP6 1FRÉÉbóâã'Ä1$ªq\ðA Àº¨F–LaÔe™¤Û]Ys¸£RŠ(Pžsbì•¶ˆÀ·’NHèct¤ˆGBGøÔÒ¶ ìôZÕñਠHqZ)n›ë»äó€G ¥0|ÐæûrûP,î¦3!‚—€Ë=D*ÄÄrè–{ˆ"ЇåþK®ǘ~žÎ`ÑhÝÙ”+í™×k]¸ç÷:Õy\ê¥{;<ø9¥"ø3Év…”Opk¸ëîÊ]>Ï<‚«IžBH„%Ɖऋ“.G‰(CK Hr‡Í8]|É ô¹šcGUÆcCÒŽÌw)ð†—®Ìaà4$0ùI“Âô¥ºÐ@ü°`!à¬ðÙ®\&ù,Fñ킃G¤¼Ë÷%rëµFÂòaU/Ëu³p-R($Í€!8µNfö.|ÞÐP 2½(³üÑüÁÃJçîMYÅOmß73/¶y¶Ü- Â̯¹#Ñ|÷Ìðb…§ÂйðZ¢ }—À«ÊÈâÜ¥fhN/‡0wéòy0$Âa§1Gâ\ Oƒ˜ìOœQˆbgGI©óMüÀnëîÀNàI‡µÀx6£¹zpÓæúón3×yµú&™ë•U?™nüÁž–É"Áx!ýމôX,¢jŒm‘è´t4ˬºÎÙå:^Vwwy¶qcVîeÑ!›¼X7£”?­‚Þ)=‘sHèéH "ȵfÛ(ÛäHÎ^›ìp´Éñ\=6‰%’aÔr挄`'e¼®nSg§ŒHk§æYc§æ‡ßN g£äCµXÅeu÷¬×÷¹®¦E²œÙbrfê~SVu"„0kÆB¨ ÌÕÅ ó`¯»ulË=ûÆÊÄÂýˆm¶†ªùKhúÄ£PÀóùþN|aŒ‘5ÆéÒG@ö„©Wó]u™Ô½±¢ mç­§DŸË<6[f—{ŒCOmh`>ÍSSŒBà1< ¹RxÚSƒßd‘Ë“4†,jÀYc~ଠºÌ_¦Ù@â=ží¡·´P\!{£›°¾òš„õ86»\¬ô¦Šä.YÆÊ¹ü—Y±xésrÀ5Fúy‚5ÈfÀ<1^¹ŒÓòÈD¾®°G)RŠ÷¦Pê›$ØQ88Ž÷9o`¦Š×SvñÀÙC©Í?ÍŽpçÅâ'Д> œ8‚¢&z–Ü^XÕº¾ƒÞÉz—ãøöp :d]¶ÜÕ,GsõÀ²Íö¶ã<Ïâ¥N“ôÞÊ0¤½üTÑäËx³5„*¸ƒ³«StòK“¨‘(pÃviR0‚ ÙÞÅZðؤzJ=­®ääѳôr¸bà#k¶:8nzãØö,OZ'Òa;¼fyhv\)Ä™«'IM»„ÅcQêMu¿+L^0c!ðWp´m'Å×0*"±¯XðÍZ/ÊÜF øöÏ)…Òtmƒ ü¤îûŸã4ÛèY+˜ì;/:/|>”@Âs~¾ÜšXñ~Gøb•Ú°!ñÄÖÄe$¢g±`0 ZiÂY^Xð®½Hˆ¦à:,x$KÕPÚñ›<“6•¶/]ª#;U•yq¤ …üÁlö^Z2T4]{NñÍvg¶ª‚…P3‹®íÛuj\t»’% »ÉiIpð>mùi—¨i—¹Ø¨Ëì¼%d_ª«ñr}=3DdS»Uü« ápéòzÀXDž†&»qDžN@1ªÏèt9¦QL½hjó¤H  i,Oœ@àˆ°ÿ 8í¶ÝŽå_#àɳPÄ/EÑ¥ËêÀáÓrzN°1Íg‘-1ÂzÏ}‘CI™E¦Q¬{»Ç¢LuYClÂdOcÙzðDA»Ø…Ä÷µÄ¦1J•‡¯·ÕI²Ì]TY+9T¡rHÎQ€6N»Z?"/G!••¼®5÷øèa„ÃIkÔSD {¢ÒH¹)ÂóÈLCÄx8¸¶€ŽýêŸ-ë—/Þ)®þYÁÍsÌ‚ßV:­„­¼;¬´ epåî§apsNš—:u›Q!8FÖ+Œ2·Ëí’N¨æ‹àÉ6ëÝá‡\§÷åÊ•N»t±o]7'$jÀ „…ËÔa\04çO‹ ¦¹GŸ¥ &‹çVýOϳÂmJ‰ £XûCC›õ@;`4ËÃÈÐayÛdüذ/ÚG›ßdi™gëþ~HsâÈ~dÂC­A)‚!KºT&! Ó[»CÃæÄ¯žH÷Ðp}NߣcÈïh$!/â²>½5ÈïµøÙ&ŸÍûZzÛ+Ûé÷®Úfëg| Âl¢Æ‘cXŒqЛ†”O;„ꊭéî6Õ!¬ƒ¿/ôŽÏ(ž¢+øsÉ\#ꃾ«ú£:]è¢C§¿C‹”9DL)buö#ùÔùbòq&A¿Øî¨Rßw¸Ûn¯¾ñ¿M­Çý0e"ÈVéUõó—ÕT…{ù¡:ײ­|€d¤ „ù uç¦÷òÖ"É÷» rø~¡‘jFÌP©&3Êwžþ#õÊî©'õîõ÷îz³Š7£¤fIÒ „s¥~Ec±…WlsôŒÎŠí*ÃÌ+ö7õ”wé½îÉ[¿ûÁ]u×wyV§¯t¦ËÒ«i“ êÝ»UaOJ…Wmù#ÿ²‡Õ^:ËÎ?õ@9NÛÁï4ê¾BòœlŒB¸ Þê-£UƒÈþL‹*©€ߺ<ÀÖÛðûv¥ÍéRÏz2p¡jËÃÃ@/{fÛ|:w$BÕõ•»þè®?Åù;]¸/ßôFýº^çP_\¹i—éÞüœÝït’ÇîÃúƒ»y’¹g? ºÉUM²m8¯wùÍ_côÕV±_››mž¤&R̪¿Îè|ß×ø…I`ßéd©×µÏq#)ÆÒoävÅ:k,¼6þÊÍðm®wÆ6¯º8®qý›QšNŠM\;³ff?ÕNQÇËÙ»,_fiÈ›•Þ &ÍžRŒ¸jnBÔ¹Ð§Š·Ja>¥PFm±ÖA¾ôjåmÙl±ˆ“úÙ»¾ÞÕ«¯×É(ÑMLjҽ«gçJN$'Xµe'Øza7£;žtïVY±r¼>ÔÏô<ÞrŒ¢>iKKÏ–ƒ´ô iy„pvW:´ÿ÷_6ñc¼Î¦Äùè«zmkLß,v…†$jœÌæÿ}bÖèÙ¶ÈL:Öóë÷üºòÊüºéx]y°özÖJ©‘}'eŸ4ƒ7nÈë8ÏÒä‰ÑÐÀ6ÚŸTò¼hÙîéÍë*©Ù硽|€à³ÝB_öǦ°ÂA£½xy–†.t—D ±ïÚ #H˱8mRrj®Hפ¹Ä¦ºR?›¢“Óð");¢‡^4™ã–Rõ¬‚µ †ÃÚ*êQ«gCm¿—?Í–ûÔÉ|¾¬S'†eÓB‰×³­ÎM!fΠUK›F}eß² µuõCõU¼¾Ïò¤\mŠjäCbZ2æ.Þn×Éžc+ª±¥£¶ÉÖÚœ§ÎÝÁ:ޤèz‘ª"3lbûŸqÞSóÍû››Wõ2¾mJú")®¼ –aŽÆª,·_]_?<< ) à›"FIy½Ø\W$®Í¢]ë·PÓúêSs˜„¨ª3¼~ºB5F—–TsjÓ®³§ó?fÏÃÖìmˆPuùMrý‡ÏÄ”‚¬¬ËóÖjm—wCUôŒeÿх˱ªêäÉ‹ŸX?Ÿ(¨ ¹‰BœBh$p§ ò”ýÿñ›3µ¼Û>¥´ó,ßÿQó. endstream endobj 135 0 obj << /Length 3243 /Filter /FlateDecode >> stream xÚ­ZÙ[ܶÏ_13ßB«—¾‘¥PH{›´ÆV_<öÔK(üõ÷È’¼¡'½O^´žýwŽ„· ¼8{…'Ï×ׯŽÞøbá£ÐÇdqýuA°‡˜ /Ä(dtq,¾,¿þ×ê¯ë÷ݸŗCŠå9ZR——²–e•fwÑþñÉ4¼7ϳ¢ª¶Qž›æ(OôË©iÿ€ÆãÎJ`:_nVbùP™–r [ybiþü,ë©Ý½ †”Pæ!Œì·¥Á÷tŸµêÍv0ËJ¨~û LÂЃ'Acò)g0”-CÄ=n¹$žá’0ÄŠå:ªÒDsÊ_¦¹Ù:n‹" ¼7û(c™×zìqò-ÊcYé/Ü>Od^¥õƒúð–oš<®Ó"2Ýx.ëM‘hnzËËUü/Ítï^ʪŽþç%J[zBE0ÓózÞÀwªL LU&œÏû3‘–+ÐY:Ѧí@•Ô˪˜²ìYÆ>eÕy‘L5Ê¡Dšº€Åæ±M±¡§"ùq6Ö#ŠÇL;zCбu(f±M]ï~::º¿¿G+²¼ÍT”·GY ¡©’ÕÑí.C›z MÙdÎÑö]¾™’½²c؇ˆ6/•“ª¿›¨”Y·ÓÍïæëô‹Á²ŸÍÏe –£n]²f^€<Ò»KŠ]ƒ °X'ï6^2"FƲ>é€pZŽƒ÷ÔÉ{·rëOYKÈÐÁäYÍþ è'Êlò”£óØ5`D—³ð8bïárœ! ½0` ¦#rC'¹>L̽‰Î³ÖyP‚¼n¶‡²Ú•²ª eN'ÏÝnŸì 6*ˆÁ ¯û&@Ū*ÊSýa¼ï åqV·š8Ð$Á"¼sïr%¥×-LÔ_õS7$id›øò>­7º1Öµ0p;é˜Ýt>s:’¾Ò–‹¢ÔäàåÛ"Ë`Aëö·P“DÛolˆ7-à„Ù„åÆåNÎÌD¿ä6 €HÚÅØ4è;¦ü`ŒQ±9èÕüƬ ãa2²8º/4”N,Î ½?v¡¹‘eÐl›Öõ„lÛçx“•i¼±po½‘['<Û‹G‚ ¿‡¯Â›ákµ°Ÿ‘ bP565i7ˆý}R+¯ëM±,QQÝ”÷iUIÅŒèk-s%ÔG¸·,²"©ø¨?¤ƒºã{Sñ/ÒñAg³±Éýç—•ÐW®wè3ÇÁËD ‚©,ÂÜkkxñFNôo¯°fHEw$0>SR‚à’â1›6YI1ì¤rΑ­Ó\H%ªöÄmcl®ìχÒ)™é2RâNJ°@„ŒÅÅÈþd½õY"!Ç›tO5麭9Tf–\/ì¬75¦’úcî!@ÈD€ôYOùQ%fÿ²&FÀUy¬órž›™áQáY†ÈÃb"L6#3Ûã÷¿‡b§™|Ê¿×Ï@ËÈ[îÒñORsærïGŠy“Þí‰ïΔÓv…=—Ú*'Þ‘Dfåí¤aÈÆIwk.D :q°ÌtNÐS?úºÉ2YŒý6zHŠøÎüýmEhhû¿D$§x輋<° ÀÞ¥Nè@hºð¤zI_ù’–›UW>A¦^ÌŽVl9Ž£DnÓø s¨°ƒ{ýñdMªÖy×#H<@š¬®ÊÆÄÓš2G”Mæ†O ytEÅ^¥Ñv¬6Í@ºè å8‡ÌÍ¥8ëwÄ’pOÖõàY‰*ÀÂ&À˜ùó«5VEÎäBŠ+Ž­¾þb»wf§ÅmÖ8C„C»÷A묀·G¦ïû=¥À<éS[CÁÅ{}Ô¤tžóÁ>§xd‡;A' 0m¢,Áw§óM­»"êÓÚ‰Ö£B‡oªµ0]Ó­ÌkûáÞù~Wä`3yÀÃÙ} ŸOÊ€,|Öý¾mÚ„Õí{×M™öÔ*gk®^Ž–£€tåJ) ƒ©—%~Ì(ÕȤ&g"_¸à©Ü‘q¦‹Qð|EñÝ×¢Lô§RuÆ)¨ºªOyþò²,b¤ÿ© [õ©ôU/*ÅÑoÇÊÒÖ熪`T° ]‘äÈA8EÄï:¼;==Õs‚Í|5›T9¼ÚÁU³“el+;4Šª ¤Âí·ûö–'ëŸtá„j ®A(¦Q@ÅãÐtUÄ©¬Mo`öËiÝÓó”/œL«G“h3(}ªR}žj'óóKØ=å¡>€+Ê:ºÉLü¹ÚDåŠùKi£›Üåàw¤«28 <¸Ô•„›[ݶݪÕ’ µ†°u´½)ÓäÖFÕów×f-UÖ²úo;™>Ǻ(¬³*O)ÐL°wÚ‹ßÞ¼;^’Öùt¢Í|¥•~Fúq+sY*H¤>vM¹+*iZv~ѪÓrºí”E5¨þÖøãqmDèÕ½|E–ßÒ$ÌwTÜüWÆõQÜ$Q»ýÓëW¿RÃð‚,8`‚éÒ/°P¶ˆ·¯¾ü… 4¾_@V‹û¶ë¬@p5,[\½úUµ7ÄUˆà¬K€êm[éX6 0øÿŸeX–ãesy¯ øÏWïÕêOޏá¿FgüS:œÝ)uEpð×ÖËå^ˆý¶å¤ÖL,S0e Ã)N›!ö‡ð÷Ϥ”q¾óî3/ø#׸o€Q>±þlÊ{u§SúþÖú¹"ãDÅß]e´®?n⾘]Æåmî0Öio/\Ñ`,ê Ý.ö:é¶ü²•ž³ææ&Í«}ùáë¦ÈoÓ¢´zv•‰ìðû2k¦Žïû\’°Ù™5 ¹?©Ÿïa£€ÄcRÖãþ‹ÅK·ŽY¾iB^Gqüäà¿ïÉzzNí½vDоÄDgÚl@Ø(éqŸbÓMk<Ø_5ó¨º)R;Ož`vλ]œfò5ªÊÓX½ªË&®Íödí1œm¾ÞH Ó¸ŠTš+`í.Z$§¯W©)È8•˜ »OŒö}žnqwªe ôö g7Q=‰ûïå¼ËëIlþUºŽ”Ï% ¦õ¸ÎéÚ\÷&Æ9Àž,”yZ§øÙ,s”m_Jð8ºFÔƒ’{*5(Úç¿NËüQ–›â뿽 ‰Á±øý¡ßÌZ6 ÿZ¦æÚ¦”®’ à#vÐáÈU3áˆõÇò”¶úüO\>T‰Ì€w,os‹pˆJŽžÏßĂɯà?~@ó64ù®¹ ²‘ zº•ö§CŸyQb *†Ù øMÎà) endstream endobj 152 0 obj << /Length1 2072 /Length2 13842 /Length3 0 /Length 15094 /Filter /FlateDecode >> stream xÚõPÚÒ cÁ‚»3ÜÝÝÝÝmpww ®ÁÝ݃»; îî‚Ããœ+9÷ûÿª÷ŠªaVËê^{wï!%RP¦4±3ŠÙÙ:Ó2Ò1p„eUT Ìt L°¤¤*ÎÖÀÿØaIÕ€ŽNv¶\ÿˆv:ØD ?eílR.ÖFf##;€‰ó?vŽ\CW €,@ÊÎèK*lgïáhafîüQç?_Æ”FNNvš¿Ó‚6@G cC[€¬¡³9Ðæ£¢±¡5@ÙÎØèìñ?<æÎÎö\ôônnnt†6NtvŽf|”47 gs€Ð èè 4ü% ghü·4:XR€Š¹…Ó¿Êv¦În†Ž@À‡ÁÚÂhëô‘âbkt|T(KÊäí¶ÿ –ùW à߇`¤cü/Ý¿³ÿ"²°ý;ÙÐØØÎÆÞÐÖÃÂÖ `ja È‹ÉÐ9»;Ó mMþ 4´v²ûÈ7t5´°64úø»uC€˜ "ÀðCá¿õ9;ZØ;;Ñ9YXÿ¥‘þ/šcµ5¶³±Ú:;ÁþÕŸˆ…#ÐøãÜ=èÿ}¹V¶vn¶^ÿA¦¶&¦É0q±§WµµppJŠü;æÃûÇft°200p03€ »±9ý_T<ì;ÿ2hðñ²·³˜~ÈúX˜?þÁz9ºÎŽ.@¯:þÁ22L,ŒF@3 [Ø?ìf é¿ðÇý;Z¸´>ÆÀð×ß¿é~L˜‰­µÇŸð¿¯˜^HKEYF‘úß’ÿë²sxѲh™˜™¬Ìì6N6€Ïÿ²üWÿ´ÿmU0´øwoÿà“´5µpþKÂÇÙýG†ë¿ç‚âßKC øß rvÓ Pü~VãÆÿÏ+ðwÊÿ¿Éÿ‹åÿuøÿoGb.ÖÖû)þðÿã7´±°öøwÄÇ4»8l†¬ÝÇ~ØþßPuà¿ÖYhbábó½’Ά"hkfý߃´p³pš(X8›ÿ=1ÿ¹†vk [ ‚“Å_ï €–‘áÿø>VÎØêãMqú¸¬¿]Àúߊ¢¶Æv&­+ÀÐÑÑЖác¾˜XY^Œ;jtÿ{´ôt¶vÎ)€u>S;GØ¿®”@/ò—éoÄΠûƒôâ3€^òbÐKÿA,r'€^þ¿ˆãƒSáú`QþƒXô*ÿEœìzÃ?èƒÓèúà4þ/bùÈûxulþDÿuvô&ÿ€½ÿ ÙþB.ãõ'€ @oú_Èú²sqü‡ÿ£Q³ÀŠæê¨7÷°7ÿx2ÿD|Ø,þ?ÄXý~¨ùgõ96àÇÓÿƒêãÙ ·ûSì#öã‡åîfíÿ¸Ù>ÐÇ&ÙýQÏü‘áàb÷1ÄÏêŸÄÿÈøÑ±Óž†¬ ÌÿðAý'ýc{éÍ:ùJzg7»$|p¸ü~ˆvýühËídúÈvÿü ÷øüéù§¹&O ã¿JýÏ»8:~ü6üýF}lÇðß?D@ ;ÐvyÑΘ;ز>¸ã¡V×vŠwŽt_=•’ÖkÙ±Óå *™²&3pÓñ·`òhÒÚ®(ÅÀ á«×ik#TX[¢bû³÷‹~¼Òì~;ìÏŒ¡éÂSÁ†A|=¯ŸÖöÓ6ÝÝA_kZy sðA“…Ä»=àèñ.´Ì(#©óê·œ>³Ÿs?pWpA€…*LNCDB-LÿÎN:W‡Ê¢SÃÙn£ÓK©=н"¦ºJçp}ðÆrž7¡•Ê!ýì鿆×äa4],Éj„ÒLhi®…^ †A“ÈžS¸8Z.]ÇõðE@jÕ¤Z`¶]ì tR6ìð¾W¿<ïÙù‹uýÓ)oóßiļVV˜¡_KsŠ:^„ÜZ„«&ýÊ.VýPáQa^Ø`"(®èd‘öøYn´äç>–£…ûßðQ{ß±Ìí­L›Ãå´«2I1„^FÇnjÄúøÍ”Ò¤Ët¿NÆñ(Ï)¶ô¼#ÆVñÞ•ïhOàõ'.ëÖ~ñMКëÕúé1æ>RUV7 N&¢?w ’A†Ò´ß¶ÀM̉×¢àóèÓ¿ÙÝ?kx·hI§ÿ:»2.AØ´n{­wò0ä;:'Ûá!íÀrPSãNtÉ¥‚°£€u¸Ý~5NH²£x;/B€ñR–Ën¯ØÍÂ` *‘6¿Àrå¢}ï¦ÙÙÿ-={?‹©CÛyæÇèØ·•‚¨ÆL~óÛ´ˆ£Ìí7ªe|0X“¡"ƒ€B\HÆW®$âÀÜë2ʘ2oÕÙË¡²Ó(SLÈÇ T‘¦Bç¤y“”¾’\ÞÊŒLÖÉ_~Ô¸ß /,Ù{IO-ÞS0vPG)±AgÃÇUèAfÂqT×fÄŽëîãZ“œE§4¯ç ÀÏæûc2b÷Ô‹é)ñ£ÍJκé+vÀ†ÒË$zŽ£b4s»?dêÉc¡/ÎÍiaî¨ØÑ©e÷\5ô<™eÄ;¦üÚL·•võ+ RÔ=P“¼m¤üþ„5\ÌØ×Ö²‹i§srÑí(Î.úåaâˆÙß(GR7,3¢×£¥ž+fbÞt1¯lí$2qÿäºø¹ÔÔ쌴Û>ï™ÇâšPž€‚Ü«,v¡~Á­âMù@˜AÎ!ò~=>‹»ÓÀ4=ÕsàCp/Vå/´Pj7ÝŽªÔ›r¡Uœùùtù<9®*TÞkV,õk¿áv†úHÀóÃ47ëzf¡‚àüu®ÚÒ˜çúXAB†1a–³ž lŽ‚+,NmínïIe¼î½’RF¹p‘0„^ ë+ç—[Áómjþa¡S’õaÊ„z® uòð07¡Añr8lZÇ„ •¼Ðä M Ä`!«,ðÒC2$¿© Qâ —ëöeÍ­§2ƒK>äY=FŠäª9rH›´'üÏÒäˆÒ;sðä|9È™¢[ r4\²G^ÊÌâLJl:9[ü´W zÑäþ«Gw~btæ©ýŸî5qsnž­ ËKÝ&–åªUí'K ªªnwÒe9ë ÷ôѤÌ~¹í¤ÀMt8 Œ©üH©é7 åRw Òõ³ÊskO4x?*,ƒ€Š"ßï3Ø2׃ìƒSQ‰•¬°•ø ´ÞûžÜ9™psߟk€²þ{q7 Õÿ÷Ò:€¼”À>|‚¢B“±õàwÅ×\ÕîÙÊRú3ù§O*°¤dgx^ÁXÒƒ\tÂg“ÒœùÝ¨®;¢/ó,îú¬áû±¹Ëm/é4·Ù%&;Ö¬äFãFë4ß$~Óäk8·aäälïµÄo>A9¸L4×-Ê&uÝöš=ϛЃƒÑAÙûR t~CÙnëBë¢Ù?Œ7Á2^ÔûØ!úKƒœQ|»ôÄ™q’ÝÅ7à Ãe7û`#y£Üd¢€ ”êýX)¡x^aìvÍ‘Õxù)hG¤ñ+ÈŠ•÷dˆ,C3ïÌ‚`ÙíWè¸7f)VV¨«pM¤ÐsW ¢n#úØ@,hG Jž¨§âÍs(o¸¿@”Ž’£@0ÓÙ€:eÊîdù$ ºº Þ?ÈÍà€ÈûͯʪzÒäPõs%³$ž¹CüÒ[8x®Ã…[ ßa°ú°*Ì óáHì;â€?§¼ówmfïè+VGð_­öC?ßžr@m&«§â9ˆÈ vvÄx­Ô£%Ž˜¸%áz/ËK½{Ò7gIwi‘]Iû);UÈ]¸;¤…4ZÍþéU#c¿Ü¯FIŠŠ²}d5¶Æ|–¦bWø"lëÃÂ׬õî8RëÕîˆÙ«ªõÎ)Zž³8/^½íϹ·e`‡íÐ5IX¸í{Œà¾ó-V9Ä;Ó”“p©’¿GãšÎeDÈÝTÜHô…ÎMû9$ÍŽ¦³HHÆÊJºÉ ŠÓÚÌì…ÔúØ»‚¬×ÿ‚ìˆ!UÁ<Éï¯øÝ®_־󱫞ûMö‡ª!oC ³m‘CœI›bŒJ?,Vߪxƒ*]~W[ƒ+K•s¤æ|_AdaGŽôG¤˜í{ÛÜ„/ €ïë‰ ®òÛA°“ïÓOò®4ÖzÃó*<hÖò$\ïzÜ0,ºÛÇ5â;ä#žBO}…Òì ¹¼È\Äüz¬Rl&Ôh ºÍ©ú*v"UÃOŒ¢m¯Û÷yåÓ˜ý”yÔÏÞÜ©ž„ÒëPU0ÿé…DϼÃ.™Pþÿ'°DÌ.éHîê»§<õwÒ ¤à;’Ÿa\˜F£œö»bz&éBS‹RJ lÚ´*Tç,D™Ñ³š ä²M¯àŸ« kÎÇdQ+¿ ™Æû«›âECðïSÞ4JÈ”ºD‡O?ë–2ÉøŸ„€°AÀ]ó›SrM Ó "™ýþ–H„ÙÆÞtåŒÔ,Ë3 ®ÁêÙɸIÂF‚Þìó Î³Éh¹o±ÃÎvøJÒÅR­ml–ÉìÓ¸N婸(Ùµr­ßð^ûà7‰6Ž—Rì*O2Ð%v×Ä0nP~6yƈ úòkLr’»Ý_A¥s´éºC ´û-ùå(¹Mœ&‰x„?#+1à÷®‘PÎôÔÈˇ÷ÚªøtöÆú¥w›¬íÐ6¤1Søf;¡Æ$Z.#?×ú6rë·}$ ç/ý[ü¤­³÷ÉfÁÊÝ@mÏôà$Hˆ`lÓœ2åIä Ü’ö):xàL>˜ÍõÎÓ¥0NÀ(&rÆÂ½ÑxhÝÀq…̱çAòì%;v¥UŸ:žQùDÙäÓ-Ö¾&ÉEˆea_ÕÝìÖ×§Œ‹îddÝÏJ(º3b’Õ*VîW–fFÙ‰&Ðt\°½;—™xtQ3`)¤…öÝå·|~•|zÇžî4+^z “ƺŽ;lvÕÍ¡M­wy#•Ή*k¯ÓK€dyî‡]ŽG4–f¡p;Gx/^Óžï•$䱇Aª» ÒGªH”§ò'g§|Œ aP9Oãïíé%Ϭ⾓~?ûZ²€¦Hüy“ <Ј]]#'Oòî®ýiCuÁÆò4>,jØW°bV—M^)•›§ªD‰ptPŽRÍíf ÛÔ™i¯—:ÚÄŽ‡'èlç÷> /gIÎèù%Rî ÉK#sJx«Ût˜:^c.ëïÚèḄM%·¤Ç­Ì½á±/!ì}: ޶¡rR„M'o‘Ó7i¯¹bUV•õŸ>ÝtÉ[v§tâTo®P7B©qfœÊdÔR")ËR¿ýêÝ‚*—ºÖT»Ïàh<ëaì}…4ù"%ÈÁ*Û8ÂJ<˜aT2¡Ø‹€wÙÕjjÜ<3—ãØØYó™ÇÌÚ7ú2%žU³Fzš7@yÿZ÷ÔV ¼Ð_ŠuAÂi+ðùn }è„þf§-rÂJ oÝåÀlÏ/é5/rñɇœÅ:y&i_౦[_^r³•;cšÞ+NÂÓƒÖÄqËÞ7¯s‚ð …]jsvñú!xi®ç¾Q9«l—<×Ó »õÔ¨©hÎØJÁÚw(ä',C^]_ÿCñ¤'î®ä\Q0¼JPK¤R9ÉMA`é}î‘HáÙN™h*$GoCÚð‹,Œ›ê}æKÊÏ•šÌ-‹â0MƒÍV*àO]Mêh‡[ÙøBªæ,ß6Üϵ6ž ÕáÐÍ‚PÜݶñM—¬Ð)¶gùclQ:£&-ä…Vßtd}æµüÆ ì\ÈF\¥câX|ŒÂú™¦“«mø2»P©”õ^²nôVou-ŠÇà“ ˜Qƒ°)vùþ‚ƒ±`õÈPÃøìšµ*Ìl.'LR(W*bYž H‚Tã¥KN9IO©C¬Ñæ 눴:‰{2Fóè½45fò¶äè£/#åUÕD˜8¢ó¡äÜøo!Œ€°ÝÐÌ1?rì_†ZCëC¼Ò¹ÊßìÄySFþ*?¾+â&¹ÙOYf '.˜k0Þ7p“ß•Î|jÔ+v@䙦¸üå÷ÔË*Þó9Ȥg8¥÷—PÆ$…ÚºB…Ø‹À‚­VßÕQM~#?4ÎòÛaN`¹yЦ}š{{^­ÜìùМ*ÿ™ðšb@Ú{XMI(iíÀÇÁpš®¹{ÁÔK%… B(+ ž{uÐýÄÂ8ø­Sƒpç)ùð…¡të‰Øß*^T: *Ÿ' HG„Vösåráêù?1$¥Øc¿Ÿ¿É\5&i4ÖÁ¯l<Š$ÊAîó 8v°,%.`?št•§ô&ºÖ°¢5€´e²ÑDL•¨›y,ÀÞ*V5â9ðßÒçgll"ýÓW¹E«jdNt3%¼«”ûjëš_îFº¡ºK®ÆñKök{ڇ˭îêqÓv#÷¥7ÁÊlWÀ‹Þn"fPh!M3¤TÈÈ: •<ÃÔ©ðÀðœŠi0SôŒy³œâöù·+b}jç$Æ<&JÁE¯ÍÒ‡Ë]ã ¥ÚÜøŠRO*Åñ²å%¥}*ÂCk¹sÌŸ±F¨–£aeh`n.úƒ%àXx ›XÌEúÝ6ý¼àôG›~Š×· .¦·;ù°×ä’0rùí;ü£¨–å×i”°c1§ésõÔÙßóQ†gñgówÚËØÈ$f’„9m?y÷³;Ö£ü$å »‘r|ûγAQa&®×7ÐØà[ã®p ©ç/½³1Ù»¥ù¤"2žHüÐ’D‚ÆoÚÌN²’¾éƒÜš 1¾gw~Èü’I¾C­ôf¿óÍqàëJX„K$£¹ÀN\¦&YìB›ƒÀrÊ9#cã'„p¶»X8MîIù»ÁkyïEûD"<¢=K`±¼ úüƒøä¹~«kˆ‡Ù[0ÞSl[“å·:ÔOe<‰±T©í’ìcJßw4ÒÌ#índyþþëAnô%·°ÍÖaÑ*Ö~âlõ}oî…jI¶‹h°$ 0r“ˆ#éÇ['¦(l/EAJ7©g(­t f—(%f0• Öx#oßÓ§žc¦çvl#AŸ€œ4œ"yy¶Ãgz$r0.ÂéùëN°ÆîÆøR‚6Pôk³(IP’;qšä÷ Yñ“âLÌ1~JㄵO¿¾¥¿³oK&â댱¥[ƒ³»#˜ÆhZp w…•nVæŸdÐâ)Ç︑Õ˶Û^¼L‚çÑ71JÃëùo5ûSÃ!tmñ؈·ºF{˜1pò•40ŸëT§*%¿Ã);! Iª4G-̻ޠ,šòa”Ú­\­I¼«,îÏì¯:aÝAfív%žÃÒ\=¯3ƒ®€áË×,±¥ÃÀ2£ûÔ6þ 5òC÷+t¸>ªíI ˜á<ÐvßHÙ}aáÛü¯ÕIw ?ˆÓq2¦”…«Àxû~xŒÁ=kÏ?ÏëñÑ3’Ô²Ê$mÈ"#KÒò½a,$I^€0†™|ÉD‘â¼ K“ŒùR˜4‹ÙünLÕ.„ J]Z…¾&¦nk*ë3­¤é’f¤ÞXåš~h̯o&kŪe7`·Ž¶‡WšÓôÃ47Üsó\¼oþågÓéd8MRneê®™Õ¨.˜(j3?xjÎOÃp9z{ÈÄéc&& ðÒ'çq zí]onáâM]CG¶Ý;ø`õ°áÈyŒß_Ͼj”Hé Õl˜—Ì;\£rÀqÒÝLãvS tËÈÞW_fu'ËJc§zÙIgHØÎªÛµàº-˜áß0'ô.D{Ç+u9àó#_U?•!€*?-ÚI.ªé @­êZ,ª˜DFkëoj5éŸY†âU¼%±Ö”’Ëq¸!ʆ“BQ‹r¹FÁFŒƒ·Ì•_–ùm'»cpOkÂÅ4ØÀÝ×M £o./ˈœ¶,øhp´lÇðûK3˜ú¢€3EufC?íž‹Ñ;¼$gJÍï9Mok•OŸjrÈÁw¤¸Œ-Ë™‹M™`嚸˜……ã¸å‘Æ\‰yü0Fù9y»çà æ°F¼ÐžždÇÛ#¾ÿ&ó‘9°uÉ*öÃ*bYÍQӞآ¦Ë×1:)%qþ]ÇxB÷Ýgtqx®×xö¥Æk¯‚‡'Ãõì~­ecÂsñ6Œçéó$Èõ·‘™‚uÎ GÈ ¬¦âL£@çïic©$Ç3å‹yjg]õoX}‹?æù ÖwÀ³‘ïü …šÕ©ðµ„G‡2"ä³O”üaNŽý c1Û§{Ú ÷•ƒëX§’ïi}Ø¿BÏa,ÓöfPa¶H WÇz1Ž´† F¤nj 6ìAUc;ÊÇSˆCƱMEaÛ%DëˆÍç´ØeÝ4By•»¯'$ w“郇ݧA©·$N>Qwmð22uÍh-|Ä#£Y•€ª BšýÞ!®hr>€N–X¦ÐãÞÒH&‰‚•žö~ZkÁK8ž’{äɨíH'9yâ[„˜ÕmÌ;”´v­öP¸]~1‰šÓ&tFnóœuÛãž51.âüVs¬§Ìq†â•°¥Y)Åb…îÔzENâHáœþvÀNL¹iC)£>¡8¿+ÞHYÕ`öÛ¿9 téWüdüwbºðžŽwS@8’hÆ+Õ,b-¦ìØï@.v¼š;K›ŒTp¸r¢&òbˆn4æVw´\mGÀÅ^ÄÅ×\ìSÛ¸u½4§¶Q®½Y¯~NÑÄÁf´Y<° ŽÙu¡]gžõ/§ êN«0Ì >}H¾ºÓr‚¯³îDÅpç¦IW¤o?Ò†jÝú–ñàýÏÂOûÇh~v+.îF5ª÷WF–ƒN´UÔ17îh534ÎYMnÓ¢º~b„0æð3y‚:¬ì=̰4d¢0a¹®Ã†©‘3ö¯³iSܲlИè3Îѱ‡Üç³§:*ÅY}?±'QW2å5„ú…A¾€©ÀdÿÖ™Ù@aÞÅ9·‘aGhƒ¨©õ,ýÝ&,è‚)Npæ7îï!5*[%”üüëZáeˆ`óÊßñœ|Û²ñ¼qÅüÁ¨o>Gf™ÍŸ¾¤`- L¤âµ4ãU‰ ¿‘Úˆ¡‡Ì©èòj!Ë%W¯è Ðköʬ¦Âç‡Y­·ùfá^ˆÌ4Ú—ì.(OXPÝX“¿áåX(ð+Õ¯»Ç^­´Ï¬r_¾eÔF'$º†R5™ëá eýè[?/M§µ|EäbÅWŠñyt®s3érÐÉûÇÊæ…&†n~œžoé…IÂsØ\µîÖ. ño“2«ý™PZ[wÔZ1Xr7L»ƒ±Ñ~þÜÜÏúÙ³ôïȵ,1\ö¾1I:u£×=s г]’½ ~&D¡i©Bþp¼Eu!’‚©¸]åÓ2;ݽpn\>êêf|;Ø!_’»hœP¿Ð+ýÄ ýF´E gVÖëÙ°»V‰¨}f£”.—æ„Æ*{! É£ ý©I†óZÓVx;,6¶Môevþi#׫PêÍÒÌQצ­þøãŠ'cæ¦ÎÉø5d¡®sy°¸ÂÚ =«2·ekåÄÕZ]¤eè©mœàA ±%/„Ô->—¬ö§'ˆÛÔ¡h.I¨_šÆá/‘„œ°ˆš¤12®=¨R†ÒÏI})¯œqxñu@=å ¡Ó=¦IÜÆ¯/´®IuÂÖ‹Fu5wõíK†^ÐÎÇ%”L·³ø~Д<M•¨ ¢ã²ß}*‡3<“ânB—Îmâ PR›‹ @ò „ö£k¾­‚(š}æÏLÔ$Ñ̨„‹GUŠ÷žÕjC·–`V$poØDtl‰ð¬íð–’#“ (R`0ÚX.<¸ b°¸ƒ~שq%Kݼ´â»ô+žJžÖO&,Õ2Єôž[þ¬½j?/%r ]¹"W;m4Ìl[ÎV9*"›–¶·ø4â9LêCÛz0/\ë@ååY%ã9¨·|’¦ñë±Ã¯å”1›%8†…–¡$õ½¬ÞB÷xv[«¹Žf›%ï0ollZ6p†x`ýù 8 õÔBz‰æÇƒË_Q’˜®z™®sÒ=ß0ñ(¥ZëÀºfoðEQtô"ަÅÊñ}Ž}‘öÄgëÁëŽÚr³÷!ÒIzü›(HÌ×8{=­ðöFöõEÛõTº¸yºëH –CV¹™kýî\t(~·´H©îáиĊ)òÖyVö¸“eŽÅÀå+ ¦ ëÝ%À&oÎ&„ª‰ æóø-/J/Ì“Ÿ*%ãÎæ=½™í5/Ö›XTÖ¥åDÀ×>©¶³mÑž„ä”ÚÄ °[µ¦<+-˜6ŽÜ~F*ir½×/ÉUõ¬czΣÇ䬦æ0Ý‚g ß9ÕsdžŸKî¶ÉÉr×Ë–H JAŒ¯ Dz¼0HiìýÞ¹ ¡“÷5¯°’¡ÂfÑE HY€½(–´$L]É&=»Êœ·tå®à3«€äfakÖ+qxg7üG»þp8ãÄaïa,yÅô )“*‡fV+£È®0+Û·OkHÏ0âï. æ)vËe#„8rÓ'“z„ˆ…Á‹«ð⸠lI±v˜Âs¼ ]Éþ©¥hÉ_ôùZ\wD&ߦ µwDŒö¿«½–ž€/ò*øn¿¨GµtÍmJIÿL¶R1òUÑ«M¤05 Ü‚,³zT‘ÐH^*ïÞR´“Çÿ¤Ý7CÔ¤½yü1¥ ôÙì¼ZOÝl êE¸ß9ø¤—]j+qEÒ¹£ì’bè ¢Ò'|A]¢õ4׋lì8êé ‚g;¦]Œmç¦9ÐòßÂòIC Fx#Q¥ê³ÅáIÑ©é-Æã[À3)¿H%ƒýúCà ÒsóÚt¦ 8ûࣀ™6u.Þz¬²7(3éW\«•ƒñê0Ø}ÀFSóeæ¡ «{â5‡üLžz>@Eã—pIl‹iûHŽéPœgEVäBjA¿@Š)HÜŨ8£êÊ»³Z7¥=Úc¨†‘ë] ºj^ 'ßR’s©p q,Âê`ÖÞïFuׂ²Ï÷¾s*fÑ…+ÖÆ}©Iç¯#"v4?¹Ê1ð|Ô7éá0âÉ81ù(‰·(¶ITC©5Ò]7œ×»Dv Hƒ%ëòÌ`Ó‚˜÷‘K%ô¸®êäO_>û2W O^À_uíY×”Ÿ(tf_ÔÖëÐæ_>_A"&×wýb±%E©•íf×¥›nHªØ\ŠJ;Ù½W$;äÁj•éïR Bå¶cú‡l8?¨»®rLE¬Ô©ûàæn•²Ë;lt᪠¦ö\0n|dz"üV€®¥ã²ç}™Oæ?îÆ¾AÊ~(U4ÂZávà==®¯d5˜Ñ!i©œ±¿ïGfW;Rr•Tjvâ$}©KžòõsÉ,¾¦v¢‡-F½ÈǤ^龟}zŸzKáHËÞm¦l9éÖÏý.2wÑå¸÷›&Uù™\9“ˆ‹zYÚRTq’ÃÀ¥-;§ñ¯“0º OñÌÚÔ¨ü›ChêWŽVÚHÞŠýø+ï_çcÆäb+0‹{Vam¢Yb` ø¹‰ø‡KÊzÑ݇ÉJ‡@†+|)m6£jz䵿ùcµi0jÖ1­x"Ž+|JI³+S^›Èß&·vpæ«j„8’FB±n‹øN¦üXu5Q®¢g-õi>ƒ£‡”? tÁ=ZBű\ ºÙýƒ:ëöîä/‘ Þã²oýÊ+pß§mYÆ4Yhámu”ª(¡µ+R’U7ûON/E­WÈ5¡ýø¡úÑ€nôæÇn»éxè¶0ÉÌNÃUÊ…H o­ ²¢ßÈ}%M²1C¾užzyÿÅ n9%#þ«ÄÆÍƒ‚ƒ!dB§í ×7¼cF·Áåª~oÂ:|,$DšqjXFGtd­6nÛõÚÇ v_¯€fŠZkžÇ‚¤÷×, uÀûç<{¯¯‡¬šâaWɬ—TYœåëê}œy`Scd>3ŸoUrÇNا 0Ï~zÜ…]ðn#ý˜¯úÞº¯)…)ŠÑØ—ÊëãìJpóžõ¬·Æv‹c“ºRK^Ú*5\üÞ#.Ä)Ò ¡ÂÑÅOˆ@‡èß®Í Ce**ïiÙÛŠ/¢„•WPy°ƒ¬šU"‡+žüÎ-hQs¬xØ»mýÌA½›¯ÉÐDm ‹ñôÉÝÝ\Šë×QmÚ'…¥ Š%¨OóK“ð k¯ây% „\©´·pËÇ@—‚ÄLjyÁéS ¸EdúÄÇÄj¬G“šŸj¤H»;N$£áøÉؽøÜ†BÓ>ïU§þn}¢'_š÷Žü’WA¯žSÁŠU®,F‡w®ox =`aðv ¹PÈâd*ËKø¸¬·¼½r‡J„¹Qt¶}u¤º’ƒö9¢U0žÏÖwiW»Êú˜œûäZ¹lêeØw¾`rº§kC 9ÍŸÕ;“lÎî}]R±&µÌtÚμÆñD¢è.Ê•¦bVö Qù+ uÜ~RWËìŒvø‚,á7Î%¤ÂªÈª¥d‘‹:×~Ã8²*¯ÓDÓúF¦Þ§ù@Q0z¦\ì„5™Û%ÔL0n˯)}Þ)ÛÇñø<È SŽ[i~s=Æô:f‚Ÿ±Âƒóð '<¼òÌOÂ4˜zùpÀ%f®Íù­†k®ƒ1šŽ GÓÒŸ f›ô7ÇG§AŠ}¸=~5—àüí_1ƒ(’.ƒðƒPò¾u²–,qâl0ÚË#$óØ¹ª&‰2”œPR[—ÕÏ{hèß0}`V¹‚=Œ>‡X«ú;;»Ó}®`ëØC ª7ðŒvTeCÌÔIµšO©•á<Ä`º™-5A¿{æ´Å1Ú/ký\nAˆw³UçN2ŠØ¥R@²d1=ÝÎx{'ô»#yÄÿ·î=¸ øØŒd«­!jêØÅÜ»Ú#Ë+ôÖYÑ;>È·Žv'èêB8ÉkõfŠFD·:Bì¥Îåªu‘ž0uÒs-䋼H‰Ð´5‚ÉÁ}ÂQÙ+œ¦¾`e]¸†'ØGâîiõU!hÙ:—¢ôkë’¨¯n =™!n·ââ®ò+2.`ÊØ#Ò× úã7N»4{ÇBEe­úØ1CfÎ,7$ó?¬žñR-$Â7Nz(N ƒ1a­w qŽñËýµÂ‘Órú¶Í°t™mk,ÑhÞs¡ä“FOî#x?æå¹³S§Éš1˜S«ÝÞ}ZYƒ¦¬¯GôN‰ô†&-õCžGÛáÿQÑ5Qò‚™µ+DRVÈÝѱ²ævá\"d}"Lï$Tƒ.=HÅ…'’’íãðÖ„·¢h¯ /É}€À3ÝC²ôI©-u=œLï@R ÖK•(™×EœV&Wïq…¿S( 5vïñyÆ›sŒ3þ…¤˜Q½¥å£?ÝÙOï#jLŒ›RÑŸk…'4ÍTÝ;KSGÏIÛñ;8¸Ê´laL!ß»£µˆûœIŠÃ›™À:Þù[m4¡%Yª?h/ŽëSÑQwV§8Y—éÞ¶l ´Ü*ÐÙm…7ÂÈ2oê‡Ô/J%yò¥}ì'œ xß‘×1^í˜,€tZGX½¢Ä‰†ÇB!3!íë)¼"})*OvP’ÌV;×zçÜ-•§ƒ»÷ëК‘×lV7ÑZÕ¢>ŒõºÑüIvþ±›ÉÁÊ+ ‡­º¨šë– J{aGu.9"ªÚghåßîÕÁ”ïº>lBª…~<¥³ñË]ßÏ›6?üìì(kބ𪉖bˆ ë=¶®¼+’xHb‚ÝåeáŒ5å6¤ª£E(C%j9Þì@ʱ€³„TéD˜]h‰m}c‰Å¢YM{B–¤–1£Ýalm›Ì¥o"Ž"g(ÛýDæw·ÄÚ)¯OŸµî§ä0úítÍëíú.ð'-Ëà”|œÛu´êöçyÕ`èÜeßñLW&=:¹)˜ˆ3òõ·Zÿß(Ø;fËCa¿°–-hçÚw^/™Z$åÃkËGålî^Ý¥\ßc&þá6ƒR–{Š@Ô/ò©w[¯€ôy—ÏÞÕXùH¾*¨h•<çÙh75ö3€?ãð†lR›ËBgß,ÐØl 9ºÆÁýUø©SY–ZjÎ{…ëp J°dN±¨gÜ <«¾¸—ïvKg”cÿ{I}ž/5ÎÝé·Œù J-Ôë~·$l£Î°GQ&¢ÛЗ ¨ £U¹O%áo`7éÐM'“û²FÓN1f2j:bßPÃÂÃÚ.RšPDÃÇMóÙ¼rBÌL‰¾äB¿T°…qü4™äd‚óél¹Y=W‹¶ÓÖEÝyXwþ8J®x=ï0-¨:{6BÄm¡æÔ^³Að ÙÊÕ 9'¥w‘§ï4íUœñЇ@Îj©èG9CÍœï‚~Í Nh&ð:˜Õv)[ÖÉ€:‰Qo¥Ò(šN>c²·†sæžk”›­©eµ©ß$¢8Âøµ øa¯û(œÜ¦Ÿ ßá!0Eí¸4|ö#ó³fÎÙEˆ\èôЧA™f3Hx2,Û&HLíá»(~Þý~04ÕäÓìX ÚÁ+ƒ}½¥ )13ïk‡¹ktük¸ìbÀ=îÍ&5&£':Ãj  lªZ>:?ªaá³b³‘²•§ˆÜmCUm§†L6ŠNyßæ˜æ%¶~D¡Kž–}£5™ºÇ`€@¤¶ÝŸ›¦> |ú'8 – ™ÈÓÑVÓJHí=Ÿ‘ôíUö…i“Ef¬r”I‚;Á›ú&•}˜.ãåh˜=¢ä<‡¹³Í[ÈiqŸ*™`çÆ®alÃôÙŠÓ Œ9¾*œÒXü‚\NЪou|²úµjÕ˜ÖIšÃÂG9Àƒ§M晟îöÁh¡ ‰î›lhøŠ¯t~êh÷}»›O»ç'HèÄ´¾b«|ÒÕF’¨<оžh;»g»·<¥SfôM™{œ:L¥§õ|'”™p• a²e|fÝ\× ²â¡€!’_Ö/BJ1„D€Y¾i7-ÂxÔ«¥ öÏS›ÌéÜ¢}Nªôè Ë p¥·…Ž^?º3ÃáwÄ…¦šÜN%Ó% cd£ôÖS"_!¨LohßC‘V[ uø¦QˆK–³¾Ë’= ·§e\#x‹eŒhc\ ¶Íˆsî)н½HbÀ ô½Hb›!‹ûÕï =;ï’YùŠ›BoŒ‡~ç/Ø‘¨ñë7Ú¹®qf¥>ÏKd'‚aBÍèÕÊmD§C™Â+~Çãå›´—D-¡Ô5 øiTn-&3™ªU¬„¡ ÜÛ¯ë/bæÍ¡þh ÂØdþ{;¹SHËVŽß›ÁX/8æ­YRZ)PDÀ§~ äº~lÀÓ¤q?ò=¡"¤S8ìøž%œU%}CÅN {bϾ õÉ’Ø4]•úkã‰.ÈÚ‹˜º_(”Qhð)ž8egæi¨–Ä´vÛÁÂWà9±Fzk˜SöÉÜ’]6ížœùê•Äì%d¨Õ™/aw¾ÍÒPŠROÈâ9ï6›à< ˜~Q¾êmU̥þMBèNWïDù”ýØÊE»„ âu¥¿’ºš©’Ð%`*r;íA6Xu‹s˜8…L l܇Bvcõ‡tÒ¥¢¤Cs€nJii/#£Ö1“î’™“{ Ñ™–µã8ÙµÕL›Ûs“­UçŽl ôàÎ Ó©Á%ùåïb’oñ J™:XñQåqõ.ñA™O0dMк¼t«aÀ¹œ8vi²Ÿ|i÷}…;<ˆ¨L‚W½¸/ î.¨â©½ì ¥KYæê‚…M`\›Ó¾}µ¿MóúAŽØæhîpû¢Ø«D÷ä̽G2«î÷&†y.Ò¸¨Úf}ðùR¾ œ»VH‹tzˆUh÷hÊ rì›Ìc©#·?¡1à3„”èÞMwBl¨’€G‡!KÖ °zÕôÒ¨»“emÛ¼N˜š> stream xÚ·4Õÿ?n•!Û›÷^{eDöÞ;×uq{¹÷ÚŠ„ŒddȦdGEöʙɖ-"³ün}F}¾ÿÿ9¿ßq÷ñÜ×ëñ|݃›CÏPPÑeWA!±‚!°4 ¤md$ €Á"B`°07·ë ÿÛLÆmGc(¤ôJh8‹³)C±¸8mÐðt "D\"! Â`°Ô?(´4  õBØÚB€ Çq+¡Ü}ÑG',®Í?^‘’’ø•(ºÁÑ hC±Np7\GÔ0DÁp¬ïJðÊ:a±îÒ ···Ô #„B;Êñ Þ¬`ÇÀÑ^p{à'a@êÿ‹™7`ä„Àüe7D9`½¡h8€3¸"`p$—ቴ‡£\sÀP] Ðu‡#ÿ Öú+@øûlˆäßrgÿ,„@þJ†Â`(7w(Òt®p@WEK냠HûŸPW —õ‚"\¡v¸€_“CE}Š#ø7= pÇb„0ןA?ËàNù6Ò^ åæGb1d?çSF á0ܱû‚þºY$Êéÿ7p@ í~’°÷t#žpuå¿Cp&²ß6G8ƒÁ’"`îÀ}`N Ÿå|Ý῜Ÿfƒ»þî(wÀG~áÇý!óÇ@½àí ¿ëÿ§ã¿ˆ ì0,`wD É~WÇ™áaÜå£>€%§=þùóï'kœ¼ìQHWßßá¿î¤hfzKO™ÿ/ÆÿúnÝBùþ‚b€ °ˆ0 &*ˆKIwÿ[ä_úÿPÿeÕƒ"þ ü»ž:ÒHýÅwtÿ°ðú[¼/ ðß:(œ’áïoá[ÅÀ0Ü/Èÿ³ü¥üÿ©þg•ÿ›ðÿw OW×_nÞ_þÿê†põý;'dO,n)´Q¸Õ@þo¨)ü¯EÖ†Û#<Ýþ׫ޅâ–Céèúï1"0*¸½ sú%—.WÝ„ë¡0ˆŸ/ ƒÿLJÛ6˜ î5Áà®ê— Ž[¦ÿv¼„¡ìn°˜8E£¡¾d`œ¸„ÅÄn=íá>¿t €„(,.À±» 8 Ðd?/T\)ÿ4ýB’`¤÷  ƒßHý‹¤$ô7ÂU±û¤ì_$†óÁP®8‚ÿX~òÙÿ!þ/ÿ‰<ë+ÉÉšPl]‰:ž£Ù.:¯u1£»ØÌ¤FIÓOV×_p°[¤¹y²Ñò^Ñll´°AÚ;ÒïÔtyï+Œð]ðØ]þ±¦*{½îåa©Ó1Ï«M!r‚þè(bIIr‚ÅŒ†—·*GFß©saöú·ž°ª¬§¶÷‹-tL•à#æS™××)Ü5÷3ÖåRV[Ä™4mî¥–Û §±¼Áûõ!÷yí0½zñÇ,DÁ¡U ¦QšõTìFœ`MåÎ2Ê•²á¤Èô¼(buã¤E ~SЃAt|Å”èaQ‰Ç—¦ M¯í«J{£u³·Ï¨Ü‚Ú9ù®Š]æ'Šžì¾šÞèé^ ­ÜWoçŒ ®úr†OPA“¥­´ñr<ïeŸ>3·¤aUÆM:iaÅÃ,³%Mzu{¤1; zT­#8•5/#<*È‚´[É*#cHËô¼Þž'… ¶( ošËITŸÃˆd±ÈçLíb<ÌÉm¡®!så TãÔ=|o9àå^1»íÔ……^l“½Hš/ ÈÍ;ƒk4Ïk]ªX‡ïì|i@– w>Hꦂí¤CŸ«Üì6›dij>m—YÛQS ½t§JŸøÚ¬1™ƒÐ e à‹ t(!̕Ѫä‹cyå„]á}ŸõÄ Qó0{}è K»é²?¶àD,ÙàÆIñøÿŽØö ü$JºðGUÃ$E—ÃFøë-½³ÅÖmfeÁË jç džöÝB«M‘Ýб-le¡| ù7v!Û-ÿÐ 9ð´ŽGÖ‹^ÊIü¶Mî—Á1ØEÓ‡Øå¶2ŒñÎÝKQ|2 v]o®kÕmßÕÉ«dØSFpÍVJ[VËòc¬bÅ=.¨2%žx”“Upß¾§å2VÍöå¨ûâ~ÿCK„¹f‡‡åã‡ã€ž×Q®šrxô^_çbjÇÄïq½xð9F>Êå·!ï¬NËP¯|Pv‡·$AWV„u–;¼2õœàºw%Ò]‡Þ¡ƒä¾Ú(·|å.Ø~*M34yþy3ì#{“^’[Nø ëü ‚½°…`•°Áз[¢wî!kî^ '4ȾÃûÕeþVÞ^Cë@»uvGà3]-|»6áZÁEBeášÅøŸ‡ tösê h6±½Šª…Ñ®ü¼².Œtõ!m‘¶1äèúC¾"ñŽæ1î¢E¿ëuKÑOÕ`¦ø‡©’÷Gã‹}Ó¯Õ\1èæ²D×?Û0¾5­{Ó*ÞøÍrõtg½Löó$×å8¶Ø¸|ýšùTž¶±up·ÈâöÔ¨s©¯7üÒ³E[zðEå’·¡źZÚm~w;>}´wÑK7èë …E9ïÞzŽ%}š%º°Ä ª<;Æ:†Ö(8¨ÙnQŸD 82æ#£Øý|‘ ªó‡Ã¨ý9’‹…7ßN÷†6e ïñ—P—úz¯ŠY·¹Æ„>“íÍkÖWó½ŸüþœN¹Óõã«ìÔRziƒÆRè‘ÝšçñÞ±íy~Ý °ˆ=×JŽêRú:SÕ½ŒLº„}Ô;Oú§ºFü¤œ' ÒÁ¡A¥ì5¶9ºÚ˜äµ0zަ]BZ ~Ju¹DåDM«/À*jÜ ªå»¡!f©[0™C§%ÙSû û…‚^ÖÓ«•4§SÞk=ÅB´ÝB´ ¹‰k¾Qwxqs7¢R%I.ì[k“ßM‚6a¶~/“k_äÙ8±Qí'YlÞTKÁñ‚Ä@íöÊZaèP’¾Å¼ug¿¢Âã¯ÆŒ:ǺiSÚ2>G_™,â V” .ú!Äg3ÉÄÙkðXÄc{Œíd”/hðÒà+Þj¨Ôž5‹tßàŸ z¬c7cVu·K¬U™Õ»Åõî¶Ü &"ÆMÂâûcç¦YøÔ@Ï'~Š€eRn”i¬?ëêðš§Úèëˆ>3–7vж*àžXƒK'—2Bdõ"2Íwï¹P|oì‘—¸àh*;†»\ÿ]Û õ—íì¡ á”ò¯rÕœR^\œ»`&"RÃõòñø áãâ ±×ÆiCI±Wë2 ‚¤>OÇm»@N»:{›Ôtï5,µxŠ^w™T¾4ã¶v’Á i÷æè,»_²4þ±˜/Þrw­‡Ž€Ô_ùQ¸åæé–©fõ—vÙ£9"*ªŠ Ò¯®kuÅÇ#y%’Äîzœ,KŸÈ᥼I‘² 5-J¦Ë©‘ö”~®³Ý7@Lð(Ì9‘V£@wT&¨’èçÅ46€éî+´ÕZŽ_^Çn¥CŠB/ë¹U⥜F„:•¹#¬ŸÝ`šŠl=ìÒïÍ×g« >ò3ÿÞ)òô:ÐÓKÙW9jE.¦Ÿ¿˜êy¹ lŸñ4^f÷v\û\¤òcþ0IŸŒhX­ŽiíjÇí÷1w ?„o^ °¿ÊVgzïÎ [ýÇÆ)ºc¥£El"Àj÷A¯aç\H¸š}ñÆ·FEûj´¨'Jøžké¨ÞV>ÞfNT6ñ'ääe¶a'+…–zû ·é5NΑéu¸-BÕ Îá*Âöáªgï|iW¼uf°iðUHÔ‹gÏæ}w½Ûïß—zFËn.ËvûžØéëgI1Dý3U+ +=:¯WZè t¿²\ãê?ϘŸën.B \id]“ikœDd+P?»hF­Ð@c!¹cÁñû)ŸÏl›…Þì‡)QîP›ÇȤg-G(¬¢ƒ®hå|F’úÄS¦lظP/^6ˆ¥ÚQI¶¯³6tš,P{'^à3ÿËm")FÒê1|ZC·'b%*ádh•ü‰¿oß?Ah’ä­ÖeÙeˆµ"½#ƒ‰kéiHýbcBÈíô/‹œinÈ'ºÛsè6Áýš«‹ý¹<¢˜7Q‰„Íz­´ØÍ^sp4OÀÂávň¤î€IF! ‘a˜nX“´«[ÓB÷È£Wú*Õ¾G<§ïÓ ®Ý‡ÏžÞ«˜©øìbÔêË fÒºsÓ›`ÅâN!èÉíýïïN°_SÔ"e ‘ S¦<ü¥©ëÓþAÁ•Ûi:«ÏvfO­ny¥ 0Š _`:ˆ0_“µ8™{1©ÏV¦<ŸÕV-oxEs$`1Õª´DM£]“:‚n¯GÒö‰MúÐÊ×o—üæyKYÈØÃ„Ž_䋆!h=;W¹•àÕÉoÎE¤³a®Ïo^o>NÇfØÝ'0¡/üÿIF“¥„°<ïq£’¶ÞK‹L¼âô=ÓˆËQé´M~ ¢@³ˆÄ«Zì{&6ÁŒÐšãÎágëCÍgÍꬴ›aG¶ßïo×~ãnšªsy(WKß­¬´‚¯ÐüÉs›*B”±9 #g°œtñÑ)Å­p$tHE¢h'9FÖ2™-o\£ËQš>¼ëSlöéô`&ט1TdVÞò4î>M†‰\XÖi—šÇrkCˆæ­^…Í7Z«”4¾`ó» í¢©ÇWy*îì՜,Ú&µ§” G2}{Yå7*ùê†ÉL›/hIj(aÄÃü]¸z¹²'G-9Ä›oL2–=h ”sJg×-ø!úäiq=ׯúÙÛÔÕ3¸x™È~¤Ð±‡I"ÁêwâÒM¢PÅZ9£kYá Á¡ 2ãçD¢É:5íçÕbÙV†¶¡3EÚ¯Uó—RbƒŸùHÄ~ì&ô~)ÌÌ`ÖJÖaLÞ|Kû9/Op9o|Ùà¾;G_—N ûà`žµ:9sÜ À@¯Uœ#¡ˆ›ˆ›'þÜŠø b]?‹¤§×>Tiß 8µÎæf™4frKR.Ô.†Ø4´’ï"§àH LôÇ:+zNy­ÑÝÚ1Ù}Îý‘Õù‘€®öj6ŠÛe1á&#í†7Ñ$ù…eÆÆ6§JCÉëföÌ[“]éZmûíôIÞ••N?^qz€­ÁÆüŸì?ue½Ü€] –Ûå"‡%TU$)¦ã_ÑÖËÜ'ð7³5žzþ0T·ì™Ò¥;«*^6LÅÒ¤ }f‚ö³uÎOz^‰Œ_6¹“>Í™tjåOÕC7Ó°žaž—‰üÚö±‡<žõ¼õ±HãðÝižåË)Æœ<1u3´Tômú«agæi|¥’°iÂ6¼o(Û½jº(Ö}¡]_Éí®Þ¶4 a§#9Ý{FÒ• ÞØ©œ«ÒËz+’úRÔÚÄ Ïã©Ux7š‹Õc[ëÛ{7÷±/ÇìÉBÊÌ“awd¨¥zºæ®dî2:dܧG«„Ê1Éñ3¸Œ:>P­9;À_§›p”ºRÿ\Ð}ðI­ï• ¿]„Œ+ωÒQ3«¥˜»æ°¨»äe¢Ô[‡yŽwÃ*PA92U•Õ*mã‘âtS³\iÚÎ$6“ÑrU %JM€Ñx5Ê S3ꑲ™ªi¡7q`D(á¿[ $.hÙ´å^¼Ñºp‚œÈÍ>øî—ßu°{úò»jèéh1CDEYÖ Æ|«ŠMëî5½ÉΑ\97øFPa]U_É'–ö }ò%âð~ r•Ѷp¡¹ž’5ôö’µ¬OŸ{®b"I¿²´ ¼þ±Ï1í쀙$ÏJrÏXµ„Ï‹fˆ¸Åν˜D°ÿƒ)ìåeª…vsJºúôá§6J¬¢IB²B¯¹ó¯VÑÕ<…ÍSˆÒ/ ^íôTo¼QŸ¦Ÿò}µ4_~[Ívò ZɦÑ@VCúEñÈ褄°bF·rNqi~ã›…M×Á±/„£•͆·÷ši=]£1×K¸¼Ñb»úT¢Y[jvB×2\ºH¸8Bßùkƒs/ä>tõÌÛÈ~üáâ·ef.Ø]®Aæs}y‘MÙÓñêÅiÇ¢7=Ÿ]Úžôñy<ƒ[ZÂþYƒ^yq{Ð×<Ÿ6Ihd|8¹ÅöŽü”˜ª›óÓ±_0s»·!h93Áy2hTåÑÃw/d‹¨K@Œê8¶we«ëÅYŠav·>¹à#QÿÜe®R.•\G ëÚ“åòÞhÝט­ßb~¡²{£äæ¾Qy¡Q¥ü‘ L7~ñvJÃQ˜ÕëfiÃ÷«÷:œý{HýÏñô«ÛȳÞÞô¡˜?rG2/%¢²…¼ý£´Ê«Óñ¬fY0U(ŒD‡tã1¦Ô}½ð%#btô…sò«ÕÅvùÐç‘¶Ž-<Ñfö¬ñîµy#k–dx¿AÛ¬ð}æÔÙ3,nQ1«§`!Ö&O]šìzó𠬟ÌÌV|ïýºûm}Þà9³¶u×[K4ÖÞ\—?;uŸœñ«8G)©üœDpª°oÁ«+¶¨”A“}i öOövˆ; =q H2+<ã&¿ÄÛˆ¯ó)Ãqë¶HêsG)jhÇ•-`õ½ÙµÞï¸ÑšÇAWÖÊ#+Àt•w/¬¶)Ä8‘›4õ7XIP”Š{¶Ô Œ—0ìÐ#Èñø@Ф,$¯ð#x¢»óUjÄdÁŒ‰ÁR X½öŒ°t Žî4½<Ù+ˆHϤ,¡|ê\J}@£VõÅ90v•a*–¨ûiù½iÍ,ºvç‘Ô1¹Sß81Œ!wòÍ<£ëÈR¿Yõ×?L¹Lfù½%(wšIZL“ôDºÄìëWвât—õûÚwÜÇGÔym xÍ¢ê åB¥\án|ùeY¹ çÙ‰Æzï¬E©“˜šîÀ'Ïsמ%s„Æ–­) %ú´‰ý2 5xêuË’Ûñ:‘æ¯'ži]ðó·,°ôÓà¶s’–ÿ¼y·’¥%žè)»®—š[›ž_.ÏG”ÛÜ–œE¤‹ØSê…MlÌZü+UkUkFrÅÅy‚mÏɳD2§n9’ìeWI¨èM­Ä«â;’/Læ5°¼­¡#d Vä¨ À‹ïïE^wŒÏtâ¶žN'¨õk½"ˆùvÐÚš7UÑ=òÙsµj0ìØµ4r/zÆ#@â¥Oã¶ÛãCÿvûɰq pòºK†Ô¨É›‘G½/lΪï=Ýp9눭©ZC¨òŒ¥9&;m·N•_C oÌF0”ùQFú/[Gù¦p{é?¢c·q »mç±Üü¥#›hž¯Œ×’ÀÞn`|Uoã<âP$a¼oI~XÍdº£`ŒZKk¬wF(=–t |¯Õ-оÈÕÞËù(ùá½ }‘•ŒZ§§¹œÚ~p*Y”¸‹E”"2œÁSÓÕµÒ0SýØ4®à­œÉÈ·¡®TöŒó¦ìàò°ëLí!H‰8!¡ÑȪdþöÌjg“OGè#\¶C,œ²£N.®ì~ö#y†ÇYzqerµ¼JPÞÏ’þ½k2ïxawÇT¬É–}òC¶6p}STyù”}Æ,i‚·26éE¤Ì:.zn†—Ù¾’²óÔUJñÿF‰œ² endstream endobj 156 0 obj << /Length1 1484 /Length2 7021 /Length3 0 /Length 8014 /Filter /FlateDecode >> stream xÚ´T”]6L Œ„€J Ü ÍЭ´"Ò0Àƒ0à Ò%ˆtKw‡ÒÒ’ÒH—´„HKȇ>Ïû¼ñÿk}ßšµî¹¯½¯½Ï¹Î¹öÍÌ ®Å%m‰0‡* à(.^n° «¢­- €ÁüÜ`0ˆ™Y†²ƒþ1ëB‘N0\ì?²H(u“ƒ nx*8ðmðò¼Bb¼Âb`0À‹þ‹ˆ@Šrg˜% Â È3Á®TÏXìüYb8a'.3#k÷ùUë.>ã¨WZˆîépÆêoWúïá*WµœlTöq¨I·YJÔ«§Y;î~óc€½³YtÍ—á¸|¯WÏ2—Îö Q•Dº(ýQüa†™›'ý»Ÿ¼-aÚŒú[¦%OïJ9%`;0tÌN&ˆ·ülá¸\Ú, TR^±éìö¹ïÚF£²8¨LYXô:5þò±ò쥗¦ØOAQÇ÷úð,¹Ku²ÇD‡ÎNfr&¯‹0%hyñ@òsîo1öœÐ ˆÈëJ=NRO¥þ0†÷nní¤ÙP´Ÿ&†!—1ç¥éë± & Í‘1sЉÄë®C|Â^ôׂ1]›qe&~u¬ÄÙÝ»£ÓnÄ‚©%w9[ŒÃÂB6ØoíÊçHàT`^må[4þ(úl.d2Sh]Å_Èç©L;Gží6ΟµûĈÉb¯)1y'HŽGeÕ|ó ñ¯Íz“xºÿîYOjO Ãê·øª¶JÖ-vSåA·U½>köf†‡2â –wÝÎE‰œ¸\ÛY^ÌùP mŒZ„*Žn},=·=*ùÏý ªZÔNå²±­KÇiÆûRõmÀÜ¢k,Ë•æ§÷°5ÝKJð«d“lƒxãÁ‚–p~~ëðüëß\ìùNqZß8È„§*øà‡ŠyG:–(/mù…¢%æM(1öå%‡ØGžs—¸Zìáðû’~¡ÙѯüÂÍ{ÇVIÚ)B¼>w¿³ñͩ٠¦É¸½¬†¾[cÈ›…â5ÂÝ,TèÈ} kÐ0U®³]•zæ÷ºÂЬ¶VPt£Sò©› ÈÕØ9§4ìV6Ëy )BÔªv¦ÑäPÓÞµ0â†g¯1Ž„áß·}Û¯€=kô¹UL]D æ´µA\šÐí&¼½š…×™¦ùhM»/´1pkØÃ™ʳo¾æn…p;®[ø„GÉeªte3ãýpº•]R7VúšàÿÚÊááU^ ó¼ºiÃ`Q·CG¾7ýÜ¥ôìŠëó†Tã«[+ÀÖýÓ0`õ¢È‘x[óÛ–Jõøë¼âzM²€´y›6¥•cÏ6:Ùgø¾UøÅ —‰m4fÖWÃïwg¨@ÔÖ¡o*D_ß å/%œêüD!WØFý3$”À‚™°²n*iÖ­ü¹¬d¡;î·Ø] ÒQCàœ”ÛWøØOw½‹¿À>éºL”¢Ío?Mò…C^ÇŠÝ—È6ød0=¿uFÁCáOb}¾”mRïÕ½G¹vÐRc•rßuhœ´ £Å¹ŠƒüŸ—• •=rˆLÀ<5¸=øi"Û{LvðS‘èÓÛgOõ3PcfÔDø$[F³Ê©¶ÌWV%©ƒØ®Ý[;Z·Rðf‘;ós K¾³¯XíðÉPQ|Œd·Þ3‚ì?-TG6)Æ™ˆõÝSólAs›|Q%Ý@R§º˜›íŒˆ6>®Ê9[À·|þ<°¢s¼{t¨÷6o¿—Öá$Çpu8¿DN‡Û‹Þ¤7ažÊ;0£}t k¿Ê$ÄQô  ²•̤:Çp ›"èmÎm™ Åoìï¢:ëI¼úxkhv‡¼ë猘ÇyÞÝB’ãô†à'vÏjš’Ø6D"Õʬr²ìõàœaÕt‰ý‹ DêÉXÍ0د©^c=â¸]™ WêDAÚî«òCÊ>ÊÑ –6Ü¿ˆÂûÝ2eéº:”Áª@xί¾{$œ“LYR®,Wžtß; žy í…?.ñ[J–ÈJn/¾+[Ù«¾>Œ™êÛæ…vßl÷L;µî ÅDrÝO&£ÎØD¯bfR-vÈm‰zÇsf.ÔcàHºÐ^Eã1¬ Uc·&À“ov¹öòÚáÞ2 ¥ -è£㫰ܹ‡OŸ[|à PH;¡Ó‡ˆðÂo‘NÌ$¿[ÎÇëgÛŽ¼²–ï9#³Ð´L°ÆhØ8ü™Îiªp'%áIŽ^5,ùz÷d\C‘Ëâ“SyüŽæ÷ˆ‹Â;1ýŸ¹·œ·ê%Ò’O‡^i’èr%rɆÙhw»*ƒâ ˜¶ýrrȇ6÷âD4÷TÞQOâùø×S|ì"*L²_–)Ÿ‹—’ÜV¦ggTî'¼¦ó“ ;}§…´½¸÷ãö•¶˜ýµG:æô"B]Ù6•Ä/€EÞ»g"hëSX2Üôðêé{õÚùYC•x£Ý:ßAÒ|ÌãÒ¨ 7s!¿œö·Ý+ù®¸6‰·‡[ÑîÖ=ÜI=í< _(èW“s²rrg‰c¥…/îáhy½e¥œÜðl¯si&eqÕ¡¤ªíß×`úšãÕG×&b²©+ãËúƒ åW+]!¼´cÒCÕcž±Žuã´8©”Wb‚ô?ºš0ß;Dœ‘+™ìo¾ê9ZH yÈÐ/“Fì`CŽI.q™øIS.Ã3ë‹CÕÖ|@o‚¤å¾%Éf³ä|·­ÜÚµóVO|éá/èÓ6äì–æx\þ<5ïPÛuë>PqØó z”±wýKò~…9tu3fgf¹ÍóghLï¬Îœ‚†Ý˜¼ØˆÕÑ,Œw»Ëx†^ͤ?ÍàÅ-fÁ34síCv<Äžq½ðõÙà­I½uI}:'²°_?zþ0Ìþã9ù;¦9Àq¨¾ó%§FU”M; Ý­CÁ€¨ü4c“ʘ´nÉ“ogTÏnu(Hõ¶6G{(]ÍFš÷1•Aâ ?,N‰~Ä7ô$—ð½kÔàxa¼šØŸá%é ®þLM„w›T÷½_F³^ÓÆ3&­Ü'7`WóZG6åŸn— ±¦j4“Ⱦ’¿}´—jM,£ÞTÑ Þ3¼%ß¶1Œ†¹97K¹:´¹& †a…Œ™äÞ &á4ê_/ü\eÞWµ}òcqRšHÓ?|Kê•gR«úÏ;Ò•}ˆ= «3ƒDŒø¯ðÕŸxH"2ã¢q†YÞ€¯êcÅ¡Ae`^cÝAü.>‹‚³œÔ7ÕfÉA1²Ïy}ÉxÒG”Ë_ü"JÔ·xÙ[•“:ŒKKpÜáe‘/2ƒ©,ëYPÙeíÏܤ_L/ÊuðþIÊ!e2f#4´j˜ÃÇo‚¸C}Ô÷仢§×à 7 ù©à¤cfíÇWþû3d^œmZ9 ¯Ø_µqæÄ$:'¢Ö†…ƒNi) ©Ôj³Ûé+5qΊõ?“õÞÚ9Ž×JÕ/œxgÇñ˜øó›&ŒÊ:;¡ò52ý†ï…J ~šf90ãà}—¬¸46{ÉtQš·àòV9£±Œ~ùGF&¼dH*Û€§ó ¼ö—ÒðbÇ  wñtç·_šJ>àùt\P^]’NUcJzèݲ5üÔjƒâéNQTŒ@¬gnéëo’y‚gÌ™3õÆ«òiϬཱི>®¯?i>¨98OWæ¡Tãs§Ö®ü€âž5ç¼-¦Œ>õZ ¤Ül'AVe‚¼OÙ‹%˜âp÷ËùÐïsh$®œ%&UÕÉ=³¤{.ŸR¿Ì¸Í§®_úidŒNM¼ ±YF3õ[i!¢dK÷[EǾ֯u‰N¿DqH—o8Ú¢ÔÉL«ÙëŒ ·ò(s>~YÜE³7¼ê= ï7 Ä m‘Zh,Ò?©¨c¢.sÝŸŽcEuÓ³èép5– ³Ó€¿»Æ° Èï¡d[\Ä­!Œ¼‚ƆVÕvÜK›ë9Šæo¬ï¿prYÒŽ`).Ì3¨»b“ |VJ„*‚~ʪ#òn<üð$•zª,£f¨÷b¹­oñeÈ*mà$7Û‡8»š“̸WÓ* º'!¥/Føùñ’Yí V¶‰hÃÖG<}Õ&͹â7FŒ¹ã”i¦©ËÝ‹•¯\‘»P[’íK1–k/kWÆ¥—ÄáYKêÉj%>nSÚ»Ó}\Z‘cöe©WÁßZôOôõ.üÂQ½¼±¡¶Ø”5Ñzê)‹}gªÎ½}ë²Ô³q{ÒL ß] ‡+BŸ÷åwK§¸·.F®DéÑ"Ø5D[nFIÉš°h²Gwö‡ì0¤Æé|fSçÖÛß×0á”ï~øº—¦ò¨ÖcÜï-¬šÜ[ÉÎvdMWfïÇ^Œ»NÍ+=^B­ÌUGɺ_6,ÂèÃbœ§Gº›øÒ¦ãmü*—?¿.{·›¦ Ö±ÀÁUXXOY$º{.Æ'ã¼F)÷ÏlÞw¼^=ôæXLVlGÆ=& Àøp… if[ôЉ-Ñ3|¸ Û©Èoëÿ z£êƒÞ £GÊ‘³M…ñÅ,x3Š1 ÷Žº¡Ñņê´^„Ú–ƒKø ^Jÿ²ž“ºööØ“ÛQÏ#LÝøMHÛq->ŸyyÞ‡ (ˆ› .#îK`çuŽ–Ê\ð •-)îé'!"L¾›ÕÆ“,¿#Ìñ„˜Æìý8‡p»6í8nboOVºw6_t–t-<¬V1åPM«ŒTošÞY5¬êŸØC 3ZÖbïÖÚiÊûEuÙõc7ãtÜ.ì âWriý97AV:ÐaT‚9ÖäþýM´Ýƒ¢`cfó\‡+ë´9zá§ø4lͨ¯†Kº¡#ª™§~yw«™ä'n„Ñb9›…_:›Û“€ºBô2lê ®#ïW¶ˆù‹BixµŽTew–˜,֧Θ CIî3Ñ·çqjgªÜâ ’U›¿ÔÍ„¦KÆuka /£³}ãL#ˆ=\S‰âf˜vÄÀ>òöÙ¥Þv#êø`â©qñ.³By(Ä¢……jø<šmŸ`¨ ïg§ ”²ƒrž¨ÕëqŠâYƒÊÐ~VwÜ‹‰}v.ƒ’íENË…"7«Ì{çñcÁ/qZ³R_DÍ•qlØ‹g%d»KúØó^ÔUÍ´Ð2V÷™8Ó¾OÄ)ŸŒ¯ÖJž»ØWƒíitñÄÛù&ÝÑVƒ£¨²…&UõúýWœø:6­É½±÷Ù;‰>¡í|—lš¹nf¶"(=Ij?šÜ@ú2W‰þž±¾gkЙšM ï}—RÉFÕò„Ïmt®7c8ÏÎM.Ψ;>gRU71ô³ü¹é\Yw’ÏH¢Ž!küjñ,h&Îsõåõ&;Ja»þ°iåGŸMñ¢4‚ѲuY_OÒ|:šDÜ%Ͻ,ñQ+ –ú³-|"‰|‚ãý»ÛÌÃ]8úfâ‘ ae‚ ÁJe­ÆÕ ºèu›U¹ý™šQI”\Êꩵ¶Ö_l4>!ð=È[›ÈѹÀ¡c(Jàìº; ØyH•âA•!v`ÖË(ƒYnüBßþð •¥KÞÖ f}»ÐÞ÷)Äxjü—ˆCÇÚñë•ÁbØy 㸣ՋÆ7 &øe+`&RkDÀ÷rÈ‹ÃLçoöÜ—Ÿ³df[y,¤ÞyˆµX2úHŸ×R:«{Éâí³³à½tí?Ê|é#44JìÚëÅÜ0Ad¢Ç7¢nmœ}Fs8 k_^[Š™§bãzºš®ÎòuØ#fýÀÏú"kØäK6EÏAgÎxt¿çneëŽåËž5ê–žÌÁ¹†ˆg>ã±ØŽCϹ”Èìe£Êšiò}|_½³V›7S«ÌÈ]´?ª!,3JUb?äIüLzQs§¬?©Éúm•¨Á‰ØyU&ªöˆî…’d«U(cˆè‰¡V] ®R¨¹‰ç‚O¶#Mv+c§ÉÐÀ$‹y†çV¤Ó7kØõˆ†äúV2Ò­cäÎ`oˆAK5*†‰Tf«; €èµ§&w(Ú½/††]ù¸|j¾?‚ýÄ LÕÞOVçUPÍùÑeÔ—È8q;ŸV qÉü¢Ó&Œ>y߇ÛKŽLZ44Ú­xû!·£’´üçÛtëBñ‘$?Jóú¿u˜}Ö£*¦}ôž'„ƒ§Vpõtt…i_îsô½¡Fㆈ“„ªœP¢µX¹j\W¤HäçftŒW6U¿NoÛâCf9‡?õ.4Á²Å‰Ð›Ž*8&¥³ýf?o 6 ,.uÌÄÀSÞíX­½ÒlΜk¾¥ÿ˽±ÝõY¥¨®Ç°æÑèSjIþ2÷>¼÷¬BkÅ«cÞ}â„7Mfvèb31RwÈÁДI“¡ƒ4qŽqfLŽ'‘;ηIpûUƒâñ$ìºåk2Œf»0„Ÿ‡¯Ž\g×Ë,à™ï«"Zú!³{Çí.ÐGÙ5¿T®”Ó0‰»OòØØî#'žæ–º?÷RY¾{çf'Ñë“ê°çÙRD#·`ªì”Y|caÙ»}Q[9 Z²"­Æ£AyýOv¦ïÆÂ·÷XVƒ…hdïá„Ïæ~––Ã-©×§BÇWÍŽD´ú~}ÁµhOBÐÁ´ãÝóB vÒƒ:*ì÷¨[]V]Z¼ŒzóË{ŽŸë§Ó_…ë<ﺖ1½4‰y[°Js M"xÍq²íÕEÈÓÊøMéi€Ä"Úïk¼„—†·›ð×ɤy{¯¥ÚJÙ7ÝRóF¯á#ÓÏŸñH\~INO›ªï…± 9˜½2ç°<¶ÍÍÜRVvÉiÐ'÷KUQTÎ4ÛÉ{y·}øìš+ ÷SÅÝÓh²ÁÓz[îXMW‡Ksc%®F+Ι¸U—¥rÜ1aÑ›üÑ3Ѩ“:'Y4ï›Â ¼ ² dX ßíTv×Ö| ÚnìEêO5erHÃé¼ör%Ù-Á‹ ’ímÝäsÅïŽi›X´³GfŒÌÈ“¹¿êÓ¬©ïˆèKû]úA¯sÞŠ8-+ß„»^±ll\–L Qv‘^§6¾ÅO|ç )„€Æa1GsHë½X,Œhý?z—¬º!š&¶`¶"ë_Ó‘DÚÓbÕG’iºRxŽkUj¢¬3]8Ÿ¨çv¸>¯í¸6×$›…v}ʽñ8ÈeS‚/‰smšžÐÅOJă&{³G)Cþ+<ÖùZKÞ>¥ñNÍÂ7÷l¸{1+²u’ÖjÌpÉñs¬ (g1L=åž0Oö³º±™›^òÈhœSÝ‘àXRG¯ÐOÎooÓ(BН°#̤”ÕHè‰ÚÓÉ„¹Ä}eÚÁAË,IJ#õ)î$—7 5 «, 埵“¶Ùq}4T úίŽíAËß!õŽ<­ÔÜiœýµ8ffŽ’T“êz[²ØýzaĪHÿ—N¤Ï5ß³ ¶ÅØû¾ð$oæCŠ}KW’äï6å5ínÆeL¢Wuç:y¶Rº8°7$<ÕXlÔÀ’Ñߟ:¹DÚ‹, 1©‹ya¾H ·åŸ-H÷¾üyzêm£â'=`àÁØ×½õqŸµžÒªDÄjÝøº…j|Ѝu²x]AiÉÖõé dûÈ}}Ê4]ÿàÓ5Ɯ̔ɇôÌyêî4##~ÇPã+«Y>ê¬_TìPÛ®h7.£Kãë.ò\bvâæÉ&Þh7eÆÈ[,¬{_‰Ÿ`œîejÏ„´ŽÝ‚hì6F’cÃ|¯kbüÞã—kÆñ½>íy…ÅžàÐ:øÛ×õáS> stream xÚ­vgTS‹Ò6UÞ‹´ UB^¥(-€ÒC ’ ½ H“ÞEðˆ)‚4ATzï½#½+òá¹çœûÞû­õþz×þ‘=óÌÌ3uí𙊩Á1m '&).¡@x"Ñ8I €„Ä•(!I! AâPˆ€+…†ŠCbКPÜ•âŒÜÇxÀI II…+g°„„Ô߆À=¨‡ÜGºâÑô¢‰áÝhœ)‹E!p„'ïCx*¯Rù7@Fx\ÁŽ7À=ú;Y€çÅ|nŽ8( ¸ÊW,8ãpXÈÛÛ[æ)ŽÇ‹£Q ÿtåcäÕ‚#q¿}Â9`¡ˆ+¸§£8ݺJS ×À¸ýNÔ“â7«&Ò»ªÈôw›\Ño´ÿ?¢# ÿ³8 2C#Ýñ]Í¿Œ®TÿÖ9!pi ùÛ²²„;ásý¦€øb‚’¿ÕP4<ЋÁ¡(OD ÒqõCáï õBpxD ÿÿþS¢”À‘°«V!œhŠG¿R#ÿ%߃â<>+‰ß³Hü~þy³¹šƒFùþÛü>Ô Yê=44‚ˆþ]ó?¨º:æ*”˜äm€ –ºÚ°ìÙÅù§Wÿ§ÖŠü+»ÿPíˆÈÿ«ˆ«îý]ˆÂÃójýÂíè-À2ÜÇàWû ü³:AÎP´7 úËøo:m< õgc„ÿêÈÿguC¢|ÿW ÒÉö@8áQPÿ†uqP¦†vBýÓ¤§6Ò7Bâ`ÎÿÚŽ¿Û Gx h„ÆùûJb’ÿ…Aœ‘0W4ÂÓ ó/†ÿ¥†#ÑN°Œ,êáõ¥¸:ð+Ià/ ¸Zs„ÏŸK ‰£1¸+ ¼º^Šß£@0¤ÇÕ‘;¢® ¯ ŠÿÃ{x\]ÕŸ“½âþ[vD^ˆ@ø `ã#Øp—Êð†Ór5o±å°4uÇ~ô!¹Å’»×ªq¨†âÙÔ˘1µ–¡•˜³9†MðëËZ×,®¶³™1 ,ãU ¤Ž‹À€>¥óMO“ccƒ«˜³¡œ±Ö*{Cß¾0(°Ôªub®X×swl´T‘¿b]àâ¿÷EܼCƘ&gºeóÍÜŸ¹çü,†°b Ít£ÂºZÄîõ–xÕL sÁ@b—Ú¹5eXs¿‹pÄ5tïÖZë|¥0º#D¶Á—Mh|jG‰Qa¥±Ôbç¢bhžI #ãšÐnj\–¦ÝéG¯Ôx×ßòª®6âÜqùœ¤¦vñ£vÿk>"(¼¿¹á,ÊÉG}hü(¥·.J&un%Ý“›×MÙ|e@u@ÆÉ¼$û:ݺÉ&]MJ¸‘@öjFª`ÔCÕ?HØ›ýUÒçeÖVØJ@Î1¯Ã3<ûÑwxuý$[KËÅCž>^*^£íYR‘øÏ~Ì@i[äì@Ù3M¯o"¢ï¾Åê_’ÏlЇ }"ªFˆ-vë$Yì&ʵŠk“ªÓ>­¯Ûû×§ü˜Xˆ[ºŸtÝ;ì‰Ñ/áµò˜7„*RÍV5Á BÅhÓf6Íd>T0g"øàfw‡àn©DÔGÊç+fL5_ˆÃø#oà_Mع~Ê8§°µlÞèìžÙì­º œ¹W°;“]‰b"Vº­{Q‰sGt'AÖÎû’É…kñi®Œ"í£FÂŒËì%M{MpïBØï0J³rVIŸ{¨[b&Љì×õíâJmýBòc`¾W`†•Ë>CÜÞ öów#°™—¶ÛSoÈW™»Aôá îÁ¶Ä4tLôœ<9!/,e,Að–à4u6ʤäY&?Ë=’•ú``×Ñî5Ï\s.¢ïR[‚鱏FùzЍ[qܱlæ`‘*IÞ{ßD§%èùK¦Þët=·vn6i$´)†Ô*ñÃÉÝóåǬœÑÖ™ÒÍK”LÏÀj›}IC´°z™¥%ÚÅ!%& 8à 3ugë7+NKž®¢]ÞNe.¡ø°ñ± ’¾rN!gëÞ»±†À¤¬ÞÒ7»¾ow±[?Þ&"ÒøHÞjqŸ°#éÎÍ?´Û€õÒÒ},ãˆ,›mTÝ5øK߃`IJ¦ÒxAÞô¼ö cãþJ¹±·5l[rÞJ>ÓóhI'BöoTEDa ÊJmäMÀùñÌÀojæ,¯.»·>ô@Èmh¶7û¶8ÂEÊ× ý8+Üùéfµå•9@NŽ%µµ{Ïh8”‚7|ðJZš‚‡OL @µkÌ>®tÍ/ÈÖm7«ÅÓÏLD´¥«ÉðT¾e™Hªz:y1ÍŒií×­æO{+QÃØMî(2ºšÚ%zݤ‡Ï34DlNù¼>?' ±ËØØî:O«d½O)b[•c&ÉÕn—*TF¨7­*ìc¶›fWœç¢ïäzR×ÀÜ‘$­ï³g𑃌£EœÜƧGS5É%lBe@îªÔ'×ÏÛ å(ÖoØõÖÉH§"­d#¿pÈåYõ2XUÓr¿L‚ØäËÖ~ìôcö[¨0Öø‘úÖ½-¦÷ãµïi6ú ¶-’9FŒ7Î6š7¾:z·ßeØ?¤ëaf%ÉËÛŸ°¨r'±’Û4ø¿OªñÓ{¨Î³ÊÑá)ýàÖäm¢ˆˆïg·Ëñ|Ô;"¾±»èå"ìÁÀ㑞…æ3ßÏúl¡®©Iƒy‘“dESTm¯4d³nøLYD÷æÄÍš3¿fwkðíú4VŒ˜¸°Ìø˜Í®ÊZ›ÕŽ—§9ÈÀ ‘93Á³!èG¤â¹TÇón4e_‰€£–°,¢p"¿Þ‹E)|økeF& ñ7úH»žë_Ù8§‚'o@fF+ýQ”á4.O r¡ù•ÇÒïïòè§ùcó7ˆøc#÷òs*ÕŸ6;¿½ß&D•ú¦Ejxýƒú¢À‹Wvp:õ.ú‰C’ sÎ% X4Ö{÷ @UrQÖ®ýå[él–Rc̽ŒV×ÊZG;nè,jÛD}g«ö­—©ÛתHÉ~œzeB4Á±Š¨ô . Œµ%Äúº0íî{ÓS6°°[—¿¥ÅôµXCÑžB|7ä3ܦ‚3ä¼gÝ8÷Y­èð×b±#Èm=[á4½âeÕ"«±“¥f°yšµ6Öá£:õlªH(ëÇ,AîU‘ìŽ×<4ÆÕ”ÛJ í° ¤cÛ+DèÛà®lÛÉ~G÷á=~å"ÿóòëIG %‘uÌBU×a™MöcÅö  4wEc¹ðßBe¹<±K9Ë-M)u–3ï…x¨UAZ5˜cØELê‡'@'Ô×–CüŒ„7-"4ë>oØ´ç%gv~‘DÒ4~4»«œž[™±V8K_Íg’“¾¬éˆ¤/˜1£äzÛøˆb ZRÎBÄ%f8*ä5Jù,똮ÖïéƒÏè9|c*ÀÃr®sYE6ÙT>Õñf÷‚c‹ ý—X…‡µÚ< Jƒêk{ ’š‚­»Ÿ3«ñª—Dš«A¬vß²Ý;ÒÐŽÅÛçƒKᆡÙ Á²²HÚzS®È *#Äˈ#÷$–OÛYݘŒ;o°;)¢Ô%Ýæó÷®'fi*–i Š’²~ªuÎ?·š³e~=VP~Z%^Ñüº+‰ÊÐ_Y¦ gaPþÅ%û=—FI r–ÅZ™ï6A`^Ïͨ“Ÿ~°êeÆY²çLºPÊ4óuq ºoÜ‹æÕ‚™Ï\ 9Ob#¾BãÏ{£R¦ÍÛ›|Á-bzt‚bÒ™OªX{,Úz…+C$ñs19+¹Be fŒ¢s&6/ûW?õÖŠ…¾“–ê¤ÈãñKw/ïä×97—N¶3¥J +$æH«êc|5÷ãj<}œËî$W{ø»¾ËVœúÜf),k<}¸Á[VŒ+]]KN)i²nYÖnWÛx¹¯é«uãÕ­wL^üpG“#Ò›VE´R`×GA“Ù*«T¾ºÔ«üOs_1FCÇ~+ 4ˆuÖ¨” eö]ZõîO2]œjà­éÙ§Ó7~e[)ÑS-8lLCrí×훼Éí$¸[Ôîâš%,?%d#ŸÉMÖ.¥Oˆ?Q¿›Ð}»­Qiµ¨ðM–U¶ñ~Ô¯rðÛŒS§+î0)ìæÖbÅ ŒYf%VP¬ñ™^®ü•§I© šÇ~)¥c°¹ÀÃI±³¢ÆŽG»÷89ÃÎ^ù»iÓ†º8”<³s©|¼Ö%åÆïðÓ.ÓßBÏð˜›oÀzT¯3ÿ)­Þ 5mÍüŒ©-ÁuÞµéXèıI2öb}>œ²U2•›4ò§HLìÈCãÁMÛ¡êÀòýf¶·Ì/W…cüº{Õ#«&/;”}b2]çÈûS-¦>H‰¿[gޤ'Ÿ›CI¡RâûR -Íÿ€²ÔÂX¢›R™Ï #%”SçIèß¶êÁ-³åeáQÀ¸¥^îäck‡É ¶­hl!½‚ÌÞÚ³çÇ7ƒY-×vŠI»®·£xm…öå0Tu·Âž?Á>ˆ“؈~s,øž ü^%ÜÜÍèY›R¿OõVhi›b>}s+„Ü%6¼QŸÝ!Œ£­áÛÂÔ¶¨)‚àh!àšäÈ@ ×d:Íá$퇜èfmé.%¾÷n”ª2S‰®š´çLÖ`‹=}¶Ò?ÑÏ?’ãQ{¬‹Ü> ïžOÚH¯ö…õ¥úÇggÜì4^­Ð ê\^üyœi¢g|r½âšÿh‹-N,z’¸Óʱa1/>¦a"Ö¤ÄíPDÈ.™§ÛIyµ¬M_ãôiÿÅpçÉ“zNGƒ·Ó«Pu5>-TŽó,®žñr=Â7fg1› ÔLÞÄp!NðÐPý¦ó„¦¤ ²î uu}ô™‡˜<Ù1NÇÚBVmÜÇ)†yG¯FÑ-b›¯´C\›,>¼‡ÄoÈÕ±©°eª4ž,¥X~YyúðQwxiˆMÉNìe!q*$qäÂ…gTà@R~@"M¦êhN@ëÙ”ú£x{ü¯­½×ɺª¥„wÜnž×Æ„ÀUY .¹…9Î…»oIîÊ×áØ—×têS¯W¼‰ƒz$çÈÉà]ïUp]­v·{¨ÜÀ£ÐúxîNNõçÚÓÊèT]Î5(Ÿå:¥g里qúÇãu;ŽÔMRb°z«Ô»Èœ-Çv±’_½™/b¿ÿžZÁÔÒszóÈí•æ~X¦¤0k| ‘,ÕúÆïgRHOØ¥¦éôö¸«Ø“tÌJÅvíµ Þ§#É5ÖöÍ{X¶0±Òr=Í~¸‚™uú"¡’ÈJÿÞœk¢éŠMVœ1 ´Da³¹5Ÿ¿´ï‰ähð„ë§Ÿ5¢ è*òÐývÞÚ_CŸ[ÄÜrû){¼¹•ŠK¤lh´^“³Ê…ü¸ã¬Ë³-X{ø}ìòœ¤‹`ï°–›*Eœ½õ‡I§Y‹ †óOdlòÙ­/‡h6Øê2EDµ_ã®.ÿZ·Ûö/¥ ‹c½ùUÏIOB8ɘË#±Šà¨3¿wåvòíÑO­Þ*-<x´[±»ºs#\C•±°›ø‡¨?›Ž+%q+”MOêÌÎúíTòÝcŸñõúBañܦ¡x§{­Øå…ÐÇ?Ÿ¥Zc쫾)ZIʰEñ‡Ÿ ŠÀ?¬×Þ]¤uiý°ŒvI)惖±m;U@MóH[0{z©íñÛ§wüàúò4Ê$¦ŸÆšûV¿RC®ÿ¦F$óB—Y¢}Áyá£KÏlÚ1nZÂ"ùÂ; —4P$›à ‹ÀBîËs.}¶<æüñ^¹îpºÃ¡ù®€7ä…"^ùB9ÝHo¹[wM4-m˜+ÛìM’Wz1Nÿ‘­3EjÇo÷Jþ¢0H¾Lº÷£yjXz8Iö!jÏ®$>Þ¹Àlú5€ŒÏý–‡ _Dצ7—~Ka÷çAµ$Ï´Q”Ljé¸qæ”ÙÁ\(û¯¹^~%ô& (*Ÿö]^AÑG~’†7àõC6ïÏÞ|j½fþ!úgÀ£± \oÁ°7KÚ0°mb7Þ§— ©Ékz‚múd>é¤]Ç·z2xêx_ôK¨¿Ù'Ÿ:/%QÒâò¦ø*´_¿ö nÈûÓK©Ï7Z¶îµ›´#MÂ÷#&îéý¹Ö/¤ËLtÛz›xË·©œ4VÎ[[ÏÃÊÝæk7#c÷æÓ³©cDµ$J뉈^c]*ˆ‚²›(ܺa[5­¦¦\` ô“Y¥3ç9ÀºTæ ¨1’ÐÞ˜~=³ç7¹©Ý É\Biïhkü’%<òQàKØŒ„š/^çE—Lœgn_J>éÒ^ïJ3\‘ÖòÍ·s„£Ç±¹S4Ë[} ×s<ëÏY’èïsù($3QTÝR­Jø6ý],cTÀÙŒQqð9ïñéö½xTÉ]؃æ=Ñ/¼Ý:| ŽŠ*–û(§s¬ä*)@á cwH0pK1½)’Ytœˆñ¾\}ö «Ÿ‡ö[þ«*MS\,¨Ö”ÿ€†¤JÔÄ–°µ§î$í˜WtZü Áíâ¢O/BÈ!qû@x@yÚ"Ø-±i´.FAdƒ‹?yd¿{jGšÎè^Ò7·)…f|6åâr7r7k»ÑžX‹Ú_°`Ž»NÈ©E!ÕT=ô¹†ÆÉ^¥FPPkðA‰ûÔF[ ~§éF¿ÝIœ0å»ó7Õcgæ²Q†—#ía½IýÉSqܪ•À|D¥’váT¯Ú!²« rn‘M¤€™ NOñ±W Œˆ¼¯Ò^1Õ¬Y­yÐl·ãN r¾—Ö™aŠ+õñ‚™g.$%92”f÷zpéÇæ”¨Ü¤…%ó£XXAñÅà hPÇÒ½gÃÓö.†ŠCTO” Û „¸X·ü?uæ=¡®-̶­¼Ý86³Õ-ÔX¡%_mÕ43– K¸¦ÅT°Ö!¦±0®yœëJZ¬|ÝÔ¬ùè¶„×qqø\‘)²ôù±Ïë.&ˆ|0ì+vš{ RéšV‘ÖÏùœÈÜÓª›¾7¢¢÷mØŸíf0ûîUÁ¡ãº`€ vßµ¿áéV´'hîQV¦mMóepW ã1CÏ>EŸißÅîéÚÙ2'“­Kó:‘­lC:ëºyÝíˆW\#wºîO}eT«Özù0FÔÚÏŸÉսȿ¯Op][oìšžÎÖ#‰épkyˆÂ³êR.ïõÀ%ƒùñЮ¤TshšÅ#«L^åË¥XÕ 0Kv×÷@›°ŸÕä‘Raæëœ³ƒ3Ÿ«"zÆB“¯ ;œ¿rñŠ•’1˜væ4XsfB'\F/êåÎk:ÛŠ1MÊçÐàwñÏýñ¦"û[}àùMÃLD¹k5LSù¢u_È‹ÔH7Ü”d“œ9ΰº¤²=û±7¶öz9L‹Ù Fʼ]2ÚÍyoPÅËìy‘C‰Õ­UFª€6RÏnQ=Lr/½í—1ë+{“åE·¯ ?m°©}ýãlX$cã^—ÌöS1J÷VžnÐ(–Ó;Úýºäý¶`k²¤Ärä¸~ÝW\¨8÷zmn³„ÕQ_v¨-÷ó€D+SïÝbÆŒÖgk0‚ŽwwÌS!Úk/\¸:¼_gõ|>‹{ùeì{ÇâðBEHÎL½Ä» ­ínDO¯UÑV÷uËP½EâùQÖhìÿWÄ » endstream endobj 160 0 obj << /Length1 1333 /Length2 5968 /Length3 0 /Length 6874 /Filter /FlateDecode >> stream xÚtT”k×6!Ý!!Ò9tˆ Ý9 RâÀ 0Ä Ì ºABRBº»énQ¤%DAR>ôxÎyÏûÿk}ßšµžy½÷}í}퇓Í$¨AØ@Õp´ ˆP  RÔ€@1! P”˜“Ó†v†þe'æ|E¢`¸ì ”‘P0úÚ¦Fÿ"à-wg€ˆ@DRVDJˆ2HY€ Øè ´p(Š˜Sáê„Ù; e¿xly"22R¿ÂŠ.P$Ì è‚ÑP—늶`ga ƒ¢½ÿ•‚GÎv•öôô» „H{y^€' í0‚¢ H(ð“2@ìýMMˆ˜`ìCýé!ìО`$pmp†ÙBá¨ëw8Š\W€4uú®PøŸ`?€ß͈‰üîwôÏD0ø¯`°­-ÂÅ ÷†Áív0g(@_MGí…€áŸ@°3 qöÜÁ6×€_WÔ àk†¿ù¡l‘0W4JsþÉQøgšë6«Â!Ê("þy?j{ÝwoáßÃu‚#<á¾ì`pˆÝOwWa8Ìͪ©òsm"þÇfE$€b"2Ò"¨êeë ü³€±·+ô—ó—ùšƒ¿¯+Â`wM곃^ÿû¢ÀPéõ÷ýOÇ¿OÄ""Ì °ÚÃàÄÿd¿6Cíþ<_Ï óX¯å'þüýýfu­0îìýü׈…•5TÍŒøSþÛ©¤„ðøJÅ%¯å*&&¹Ö5ÀÿßiþnÀ_äY À°ß—û„šp;@êO×Íû‹‡ÇoaðüÞ^À¿+è!®å ðü£~K Ðöú!òÞ_!ÿ?éÿÌò¿ªÿ¿o¤æîìüËÏó'àÿñƒ]`ÎÞ"TÝ¡Èÿ˜BÿÜb](æîòß^M4øz1áöη†RƒyA!0´­ÃŸÚùe‡^¯Ä¿cUá¶ÈÏÝ•€‘H°71ðZ ¢_‘ë%ƒ@½~i ,G ¯C®îh€Iüs$ââák#ìúËóÓAü¯ä¶îHäõâüšßuå¿Î¿¶ õ‚Ú/Ì"lï†8Ö†´ŸV+2y nŒÞ›âÜ0}Ê+軀ìp?''Há­Êzòy¢˜2ðŠòíš*ÏñýEÖï¾»-õá­I†m~—Ö FmÄóãt}cÏwë^ß&b4¾¿é÷ÝÍïAn v—g®›»4¹A>Í©g¯ºWÝëÒ¥á°Ù ÃÍ*Im’ËÒIÁ“hË âiÎ<›g3 ìøhÁÛ„|ÔŸ½(¦O¦¨sÆ®Xµø‰ý÷bÄ }ÍWDcÏf|–ËEQÝŒŒæ ·q©‡'¸|•¶Sµèç|K ßöÍ{5£ÛIj éÛÁéi6Q‘Ðs¿Ø²èUœ­†ñ`l2yäˆ:6ªlÿÍ©ç(D!kù<«;ÿœÚj†DR« §¼jÂV¤=ßÚwÒ‘HVÞˆJºM†Oy_Bç•· æ•yqt=€S‹‚>ñ ,²ZÙL€„³./!÷#©êÜÏÅ'ýim'ž¥›Jhû».k;öÃO)ã£Á“¬7o‘P,ë?'¨ ø„HTåÁ©k6­Ud­Â­°– ¯¶yŸ—qTƒÑÝ@¯„¬ˆ”íÊÒ˜þ8âÓ ?Öe™½mèßDúÆÐf1¬Â`ÈÅMü/ñè’Ð/¤«£RøèVáª#Ö§‹ÁÝÒ¢ŽCsõä5»ûÄw…qh—nqô\­—»Y)›¾¶K ‚Yiï1‘¦Hn¼ÌŒA •}p¥R^pŠâx%´$ TŒc\ÅÚsï½ùØo`“q´(*ÄΣh62›çòÁÑØˆ4»CucŠ/ëÇ"cDF¡+ÛIÉ‹ÇììÀMIÎa5ë۾ŕµãG;®ÞÍMRþŒèˆ  !öE¦õC3侪ʲbýÇbæÁô>•î• ã)õ—ŒÍWëŒsC fßäUõ¹Þòb1Ž>"Å›d=©FKñHíÞ¡°µXìǤžÕ´s]ÙM[¦±ÕÝkÔe97wü$,óil_%­ C—«‰´è)<5Ýg ò pMP[dÆ•bE¼¯d+‹£#úÏ$^žz{Ç8ml*~Cúû¢rñÕ&ñÔá5Ä`6>+ÿ „®$¥§•æNº1Ëþ}A<¤XM!mÍNšp}ÿÃË­ncÅD²-k^ú¨žcØþ¨±¸`[ûÊ"!Sw…KÿîfŸ;à~ûì!Ý•D,_œŠ(ž0r”HÛ‡ÿËŒ5ëͰà¯S®·ˆK?¦°l7%|żª‚Á2O÷õ1‡Ž¶`-8×–"Ãýx‡ƒžŠgÌÖÁn¶bÚ_ªK¤…«OÉ¥FI¢¡*©¾TªÊt¯HG[z:ÞâÛØO «AÄ–ïèÓ0ä â7[Ö‡ h»Þ?Áñt³§wo»S/³†Ë£ %[$À—ÅórƒñNO­äͨ Ò=Rj"H858ò‚ ’ÅâÂ}«.¢Ô”7mçß2…HÿøŠfØ“ú=qDó¶ÔŠz]TÖÌo¡76n¢ÒzZ“:¨žgœq ‡øT–ì4Ç’1è’ˆµ‡ål¥ "'¶tÁu®ÙÇŸ»–ñø;MhrªðÅe…V8xÎY@¦À³HZ¶*“¶>çÊ×€â“Ró󒆮٤›Ȥs®ÛØBl¬Sä{›ßýjf”õ¬ô2†DZù –ùUµt×h¤™ì>¹´!ŠyQsJ|(¹øe¾l`ËÜðÕ³U‚!§cƒp‰£ºÜ»|®»êó™§ÚâóàééUybê\K_'oªa•Ä1÷..—àíwyYë›ÑˆVÖ2žµ¡½ßr­å Ê£-‚Ž,ÆW|8\3MâŠ6ËÍt[ùq./áS‚Û zDuDÙî¶Î‡§ÖÍmœR,™ð¨4›Î­ê _ªZ ÅÝg£U¢¿rÀÏg³Ö¦ˆ ,TláñyûbúÈ%ßò¹ýÕ³RšG©ƒ>iÝéúo3*Cå*Ô%£[åX_42'ˆôM­]¥Õµ ý g£ø¥ôd„/ „^1 döÅâKoí¥ mJ¡ƒ¬¬Õç|¿q¾ÆƒãQbžÖ¬ÖqÑ•Ã0ÄÅojìòÉGMe:Ï#v;à®à ‰íwp)¿EbÂJÿÁ|Õ¸âh^Öˆý)»·º¸ÌŸ}Ȳqw×É4ó¿ñÝgð5Ÿ[¹6%ïßxªÂ¸ÿêôÅ»{Q7©ž%v˜¼¹™²Tæ<ì›ÊåÆ<òÑ3ÜŽ“{ 'õe±Â‡mé°lð0u`ö>y•uu!cë?ðe¹{Ö6Ø¡(g‹ïÎß?‘¦°.‡4Ø»¾0V”i¬‘¦êÊm;ˆò}¯‹wníýp/Ô) hÏ?ž(è]r¾v<€²ê•­qç÷8È:É?fÚÚˆQÐ>æ¿'F.P•Úâ…#Âg޽»éâïÉÛ µT~ý.Ž*æ|kdÒÙ0*Þ½©á€¹uVç”͆ET;¢zÙVC`~eü”µ§À•©?0†Ü¬¡¦ØÎ„•ž Òn™—Ø8ñ‰d;•þs§ wA…) ÏdÊ\¢ÑžNMÝ\—d’8 `Ó],}aдx;h§&ÏÁî‹ÙûYÖÓüô¶óÔí}ϼ¦Ôè‚q™Ú#«ž[¤Pk±Ï›m£)XÛÞ]6ºC¼:c¨sĪk)©bp=ü`{Ã}€qµ81Õ,æO£’þ组=”ÔáÞ¼ZǦɀ4Í”sV£ñ€”D9KXÕ+¿øð–lçÁÕWpQ¬ÒªX.0äüã®Ë£F¿Qu¹Ê¤Ç' ðÞq‹}’§"ðe,ùöÊ#¤r¨^gó†ÚðRñzíýZ¤Ûæ|xR…“‹„×$l¼!ê-Úþ…£c*Îå‘ EŻϨ;œ¸ÃUÃ%2×A,ˆ¬Öý·cTB¯SÓ©ô“…/^E&w3¸ÄÊɾîEÀ Ê€R²åX{ÏY¹òý3Ýõv õr:4VSçeùA¤*ykFŠty&F.™¥Ë“<²+LoÈÚ©Z€þÉlö„½4®ÉCù«we¯Ê†T¸…Ê-jìͨJâÉžŽ65 û,–­(2þµúÈÑøW®EâÛ£î™B/D?«(…Ùe[Msõ¢ :êÃYŽdÇDöæð×äÃŒ€J“¶~¯{rvŸó|».œÚ-×p?=£‡ QïµdèH1DVŸE1F¯kÕp‡Ç+6¿lUpð?9bc­pbݧ! k¬ÛŠ×I½ç}J/ è(Š3íÐGà:Ó0‘4‘-R ÛùÊ­˜ÙM9nš[M9‡ÚrÍçÒ±Zô>ø§GmÞ¥} µðÌ~Wú p¿Mý5²Î2œâ“§FFnÄNÏÎîYÁÜÖ¾²™¯rš©w”ï&ÛO9…ö²X2¥œ`,F»7Þ;Å–È+Àˆ–Éx¥9ι^òŠúTŠÒh“‘?w4=[w)\ l +PZwÜMn'Ãÿ‘egJ÷Xãî÷E¢Y>sé´å#M'{ãzSÝð&ÂAf]Ⴝ¸‰%ÅÓº„Põ ðéûƒp]UÓã}ÇLdÚiA¶1|Y¶Z°½£xˆ9å©%»7}ÉLÝ4V'–›° K—â°ÅœÎ8¿³pN…ÊÇîEl~_´÷snx«B¢6cp®š9hAº²!âsý‚–aKc@¯pTš#á„â3¹BuéJgRÕ›8>%‰io/Ú÷å•Σ­ÇÓ§^TÇî|toûy ai(2 é}e ª*5{Y’ך^º Áe%:ñÇ[bâ™ïëô*w¿ÍGß W‰©åž¥2R_ݬ¿‘Hýüö=Y;6o3 ¬ÂG±yøsƒÕT½»ºŽ”÷‘$Êä½øÔ`.²òï{9ò¤4`ƒ')ºSb+Ü@>]VM»L®ÅìER‰ÁrJ›ßòK§Á§ ,(ÇÌT =)\¥iRW‹^§(f¹³%‘¼'YüZz„2U(¿~UnÞ>Ça{mÉœ,nõ 4©&vŽòùJ»¨-ËØ+ÃÆé‹T\PÅCØÅÞ½ºu6‡?.†£ÄŽÅcH,ÇÄ^î,cÉ—†Õ'Šar.!å<öIG TE÷¹8ÇÎó†Ù·GcïqÄÉú½Óª¯.úõå㆛ÓÞô¿&Jl̰ÍDsv$aߢÀ3×ÌÚ’û¢ì÷¸=eÁ·,T\?#­{gÉ™ücÙÅéËÀ&-ÐáÕià äQ]¤ç¶Äç\œè!n§EÃÕ>~ˆ[xOÎÏ¡ê`\.SƒWE ¦¯Þɸa„‘ôÇn»‘lBæ\eÙxÅ$(C/×·¡ŠMP8¼FN˜»t±s›`Ã/å.ÏÑø«ÀA3ˆÀ³S¡Î“Ja«ˆKU­J҉ηPõÔÅÕrßÍ›dD¤çT³ª·ËÔåDuoopl\¸”[“|4}i­aÒÿFˆq,³©É$Ï?&Ÿ²*N,>ȘdØqàeÀZDÎ8_g’ÂÛãPXÎéY_Ip$V½ÙjÖ{"8•üÉŠfþKeg)»KB>Š#j4qG'Ê59ÎÎî/{zÖcðÁ¿H«¾³1éåÎEgcTî4“#цEE”µÅd4ŸÔ /ɶ4ú˜¸u4.3ôõf×M­˜„xyê#NÎù» ‰¯*X¬+E± wb|¦¢Ý=BKà J¯ûøx±_ˆê½ÀŸønÞ#Ö c§‰u#°°sΔŠ|mÈ}öÌj!o'… ˆ+Ë_m)õܾä3ßmB¢øìµU Ÿ–!Óc=/ä…©¦ŒÄLU×%úìÊ]‹&…i²Û߆ÓõÞ÷?â†ðçD[BÞÝw€ Èî\Åž•³&á¦wFjjHñu½,éÁQ1¦Ô:ͼzñL¨4wÞ0iƒÐA{[*È©7æQX.у¹Í€ñì0ʹ …?ÈËïXíÜCËU •±Kð W€E±ã:Äc6ÛË:ÔAû7†ùäõ'á:ó±~–gÙ=Y¢ç¸Ê\JžçÍÉôÖá8s›Ñ²C¸\o ô{§Ÿœ¬}xŸÖÑ¥?+°!î8ùŸsF„"˜: ùÅp7ÛJ{?Ãúùèt!íÄ(Áˆcÿ€SM{Y‘²v×[>,º¤sRï=CuCN7Ï­oüH§ÔúRnó– U†9zÚ˜ÚmÌj©n#oˆbXǘ‰û)ùRÕâÒô“¯•AŽŒ|§1.wߟ‘€·ª&ñЧÅÝiRvŽ “—U¿¹G¿;2F³U؃=žºü0ϯ{ʺ”ÑôÁ¢Õ“Yë" Új/ªƒš»Àöí|y6¾Ó@QE-]Žíƒ¥Hç4'N&„zXЉÎPûNÕe*¤*?@€O]·}W'0¢qSÉ"Ì×9,L9ÞSÒjw‚ˆœi™*’šW´žÓο°ÔI>‹ïhî‚ævO?ªÄ½S©–ýÄQŽ|øîADãí§ÑTBjÕ´‡zb²b¥ ÕºSròÄÇŒ|V¡zG1óµ¾¥Gâdɵºµã5\aÚ§&¡zmïâõ¯²£>´ìàsʸïr¡?`Ö,U="ÞM—ˆ* ¹f~õfJé=èI†¼‰èÇ?ðžš{ì×åalY²ç1Òƒ…·$í™Þ©=$‹‹)[Ì‘³n‡KãÌ,§˜ŸU¡Ø±¯È¼Ç™SÔ•MyæÊ`¶1w´‡ïä.ÚmÙÝi'DÖ„õlKŸÃ¬`¢¿ à•ò¦0Ü•†'7}ÓzÆ4¬Ò—\l»ûÓBc­Êyzh'í.ur³•±eL¿Ù‰íü9ŽþÖØ›>«‹%qÏ®¯=xŽåªôÕsHÁ%öÈã„ÑûØæ;Ä›<8*¨H·6™œw¿Ç ~Å€ùõ°ôP¨~‹ÂXN´”è1Ó̓²ŒÞ‰)µ­æ$Ÿ…-ûöŽÒ¿L”Ö³ed¾ñiÞÜö¡¾ãÊ01ŒJžË'Sþö…ÒrX"º P—7lCI³ŸF½´õº:£!ÈU;;Þch“cÏœ.޶¸¢mðAJx±ÄÌdcçú:ªv×f™Dï îc’|¼ÈŸa3& ªb~ð‰Jî7~ o¯A±§´ã5G¤°‡Š¼=LÐOð1ÍN™|Ä­mSì{ù^ˆ”¼n)ÃLà;^]ñZƒcv!ü›]&®ÐæÔ™â3-?S´ô×pV쳜~Ûä=âé~¼Dù±D[)üÝgIhïªó´1ý Û Z„ÿ’¤1:´E¾žjñ0nzIA/Ò.ZnÔœTÒÁS·òFˆoŠÞþ­üáXèýÕŠfJm'O(Ìsþ„ÀºøÆ6æ­œnÞ8}IÇ:NÓŽáœ#~˜Xv¢®1¢-›ì~5½Û°|äIÐ ;]*Zó¡½Kùí†ì ¡è¦m›`3&u?7Ï¡úÛ3¹…/àHãyÞœr­vz(+—hJš¼¿eê<0 ÏÑ8Pª]pÃæê¢©ƒa–´# oÒ›F­í¢F‘J>ï$Ñ—¶,U|æžwûFÿž)1qoøÍê÷Èr}䞣SµÐl®f±”è¦á~ð^´n¤C”|>S²#'Ã]ÁþòseêÔ u*ˆÌ¿Vó;¼õPi—ð1Ÿ Pwƒ1º¯—.ÃüM›@dai—ÛŠ§qñ(‰UlÃö}ú1Ãþ|ƒôÅlNœ±²1K«|±%: ›n_n}=ÔëüÃvþ“Ú¡-sYx(»@3u†#$?Ó® ¢f5-¶—"fó Çv̲ô?º„{ öÄRqÏ_¹‰’Ø´ÎŽÅÉ 1^Ê=ÒÌ*ÍÕRÚ@[¸ÜÁÖØê•¡%‘ÇXõdòYøìîÎQvÍtw¬¹/V‰¸ƒ¦©á±m¦8uK>}ybS¾õùÆ•ÖbÇS[k|Ô›_^^Ï-Mz¯wƒã^²/z¸°ßvaí«=½êSdÒ1¯çˆØž!Yz[S©Qvµ'Á.ß# Ð‹Ñ©f“:]J[½Éˆ`SÜ¡†Ó2ô«oÁfJ]à£jö÷4É$µŠ/5o½`n};3ì%(š¼oÄ¥Âés›¼íÞ9\óð0ñVš)³SÓÌ.÷ÿ‘D2V endstream endobj 162 0 obj << /Length1 1342 /Length2 1316 /Length3 0 /Length 2172 /Filter /FlateDecode >> stream xÚS 8Tû/n7gJ¢ôW)Ä< y¤†ŒG”•¢l3{Æffïyì1&"ÜJ:J9Ý“+=”Š’J‘Љät<“žŠ“èêìñ*Ýû}÷~ó}{þÿµ~k­ÿo­ß24ðð4cñ°˜¡¸Lµîžöî4* Rd*•N24ôBp!JyÜio…‚03&˜™Ó 2ÌÀŠ8DLÌ3Þ1öÃV}Ý7]P>,GHÝ#2ª £Ñµ1+¬Ã=ÃÀè«ü}©L*—øÐþï%ùoÚWeùŸòÿþEl¹P8ì7ü‡!BåÂQ.„¥ß6Á#kìó¹è{¯ ›ÁBÂñö!26 ó<œ8"ža;LìÄÄXG”‹ñTËCgZH*…”$*¡:1Æ0±e<8tXœ€BF1œb9ø˜”¤ n(b!„rƒ1b.t1BSHŠpåR)±AÃs$^0v^W…¹¤Æß0®MLPnÌÍþ‹,=…YG5Ý\³ìý¾^MíŽóBžoˆv°ýôñ¯øÖíúÎøOh½¤Ÿþr5xójð¶gá©ñÖs/ßœÂh3 ¯ÑZ9ðRæ&§w®½uk‹?å æ¼-à”+zW×Ï5•ôt¥Þ­¤3[Ëžœ5Œ´¤êuwkŠ×ö¦wÛí*±Ð]ë_ê ÛKu¢{oÆDȪbõî »«ù©Œÿl(JWÝÙçö–Ùtz{:©$عq×eåÞ’…gZ®ßk¼s?IÿÒ2vUef n|¨s}¤ó“gnòWDZy·û}OÖûa%ÞQîV½'-ª_eHÊi‘ _¢Ù:œäìæ^èÒþk庿¤æ÷0Ͻ(иBŽÜ²°/®£/ü”W…î²æÌwú̶«öah÷€Âš<¸Ùæ(ǧzZñஇ¬[°¬ÂK˜u“4lm“sû÷§‡üšrãCˆd&ù5ç¿"6f¼šá‘®n3pÍãÇE.Y7îù—©í{Øì¯ñžcÂÞ»ÁeÇiüƒžrEÚîó锸ìÎ/ýZ@Ì)Ö.‰­°­}]Ôvq£æÓuJæ>'„>Û&Ÿî™š¼Dç#rZ;ç_/âú¯œe?Ͳ´!'©Ç¼äÜËêj9'¢ªe·T)”Zkr¦Ý^œ¶×yrO­ÝqÊ¢íi¿gõÌ'Ýã?øÁ#i 7.Q—k’·`ïÍÅd Ÿœíf‘Ã_+Mí‹›ƒ“Ú ¶ªqNj6nPmËÿö¢¥Ô¨Wî»b!î˜*€‹MÚøú¾>óŽf3üV×T‰ ^µÛäÊÂ";£÷Ü*øÒø.M›ÔNé_å¹ýxJ#íQ³í&÷+=¦wÆmÎÂØî»« RRúBª»9ä áPÄ™”ØÅ’ôçWÄÑc½ŸkþpÛϤÉãê»0ȳÞ(Ï+Ï©ô޹²áÖòV½†Èàƒyô©Ë/? ßt,û‰ªVl&~oÙö`^Å”O~¯+;3›¯ë¾}c0³vÏEIô¬kü-÷B å‡zwÿnâýg›ëÎÈò® ™·‡úÜX–y¹…]KÏOJÉÛÎònö0ÃÃgo·©|–uÀ²:±»Ô‚s‡ýLŽˆõë¹IE⟦v%í úA¯£ø³oÖ?•tI‹–ö9egÈ;ÍÂ"³ ýÙù} åÜI.‹[®ÏoÊ:` ˜[º]çÝC„œ1Ǫ»õ縖ÚîÉV¬õg¬Ÿ8ñ*«mŽI÷œª¿Í»O°·mrÙFãÄãóOœèø4#ºx•1µÜ×âþ*ÜÈD;(ïö=ÅngWfk¿Ë®Ùp’ql3%÷†‹¨0Ç&+±4ü=³¾ô…eêÌЖ‚ò­CÍd¯­¥5ÿä‚ú_Ff=4e·Õëét?R“Ýt!å•Á:ëUíù¹åÂHçÚnNÑìNI±@Kú°¾Y× endstream endobj 164 0 obj << /Length1 758 /Length2 1033 /Length3 0 /Length 1572 /Filter /FlateDecode >> stream xÚuRiPSWÅ œXÑË¢R%!/$€q+a3’Р˜è#yIž&/˜<$‰JQ„Ä• 8®Ä¥‚Š`aµ,u¡ .h°0•ÚH§âtÞŸ{ÎùîýÎw¾7ב·šì#QE!* 'C*¨q- <(TÒܹ¾jÆQæã@4wˆîN£R©Æ Ä$<.QÆçÆh`ÙP•F'OoˆD£ *ÆA"C1’ûÐólLªç/‰‰Õ6#j ѸM¿DK‰ SÄ "%îÅ(Á°®C¶¾Qa%ªˆû]€ 29\¹ˆQŽUÙ8¬@Å>˜Lê…jP-"ᡸX¤°BƒŒðk0 ¢V ÂSiСD¢RÇh¡rT¼C4Àø"«pTLxã™Ð ò8c J"ºÑ÷`Ápà=Š%ÈAûB ˜dl D¸Ã!¸ y|oíÂáKþ˜X%A1 1<¬VÃq$*€Ä: „u-@´Ä°îL…W@t ž¤*5ihCÜ¥ÃÜ0¤{wÖȇ™¯Mð`ÃCã¢ÿÍrÈÕ0†Fðj\­ÚˆP .ÿo ÆÕ¨VD¥P©Áßè)âÛ)Y,•VG†è Ó¨^DFÞÀÓ›–øU¡8F­&òþˈ¬F±%ÖŒ ZDLjmV‰'o0$_í?çcK~^gÚÞYž–)¬ÞÁÀç=<¢“sÌöÞÛÄZ/9m{'×r"µ±9Á~Á›þ»Úðʃú¶=+òqÿꧬwä£5*eÈl‰ÊNVï•—öÔêmVˆÃÔõ¢‰¢ùÙ‚æO)^7<ºÎ¼øy°\Ó¶¨(AáGKÇ=öø.ŸÃåÝãÓ…Ž.øma¸e†µZ´7&”½¦~p|²—ó ÛæUN}xª'³‚û1çBîÂÅÈLó›"C“ãœùŸY:«ÑÚ…^ƒIý¾Ë4ecÝ7´ï~3èÖ´ož¸î}å“»·Aï,ãψ̗µÇ•ô-ÿ!ùY¯H_Øda89'³­#/þ@„ׯIü¶â Pû¶ ¶ÀdÏ@Q‡{å’?X{ŽüÜ¿ò‡»+‘ôx'ך\[¨åÈÁF,!|‡¡çÚõ$ž ãÔï€íL|ò‘ÊÛôW Í e)dÑV¹ÝšÓì«—.ççäd»íˆŠpy\óàaïËÛ³~ÏkfAéÞ`Sƒ¬¼ú˜2Åb ÿÆ/M/·ÚšòŸ²ÝkìøÔÉž–»¿s\VyO·"àšdµÒa„pÜŒ6öŸ÷ß/Á¤'°EL:vÏùEDZl'ú±hIçÑY«eݛڥåü³=iúÌ€Õ«¤«WÉ«v²‚œÈ]æ3œÚ=¾Rç0tÚÖØ©xÒk¨>h¹nZ•+'ß¿5ý]Ï ˆLù3ï³ÏoF+Ôÿǽ‹æ~Üò³Œ¶ú‚ ‡òJ{··´Gl“çG8ʰ -³5»òò£”oz£Óå.ìÝå;=¿Å&,tÊòcv¾õ–žó÷±žñŽºhzì½y/®ë± ]¯¯ï+6Û~äóÝ`&'¡0mÜcJËq3‘s /šsPÔ—i•9«{ƒÚäZÔ:¨+oû劃‘o}46“|¦¤__ɺúœòÅ endstream endobj 166 0 obj << /Length1 978 /Length2 2335 /Length3 0 /Length 3002 /Filter /FlateDecode >> stream xÚ}Sy<”k¶”-JÙŠðÚ"Û,b,9¾Ih²}íc˜13fcë±¥,e"$‰J˜,-I‹"ÙI"[’¥d 1¾Q§åt~¿ï÷þó\×}=÷r=÷«¢€tЂ£)>s ™®ÑTz èhC„TTL©O!FÑ1† ‚è‚ `0@Ñ9Ès@ZsdÎÖ  »©C}&h¼/ðÁ`ñd!Ðf~Ù@ô¾ñhFÀ÷X†JãÔ8E÷œ’h ™  1~œ{ "ÑEÂj_ûúWEÂCÿÀƒÇâ耚5g~"è("ÞNÆ1ø…§™ãC0h$žî‹üPDæïDFc¨D<ƒ¤Ðð›žZ0ø·˜#ïK ch4@÷ï …Ž÷å4çü÷Œœ5 ¤Õï`Hó¾çCÑ|1d: ÿ£1ßè߆ŒþÝ޽_]9;ظvÓøöŠ_cfd_ OÆP]=E¥¢B…À„ƒtp€çô`B8Ó‚´É:ç À G~ªÐæ#A E À¡6éo ù`è? ]äK!‘~2:&€†'rFþqMaQ¿ªô8‰°›+†¡þà8{" ~Qq⦧?’sQHì/ è  OAÿqz Àá!?ërüO¨€¨8ÊÏ*œ1iD ÷•ù§»HžLw ø±$›vÅoØN¥0.x4÷«ÄE§âC<ÀÚ`0„Ãs¾ï§cÿ~¾C‡(!áZΤ… ÀP¦ø‡Ð—A¥ráëÄY‚ïØÏÙ_ &ã+Ô×Cñ5:á_v¢j¹.¬5ÖÊ7ë% CF¥®oÉ ÅuQ¤x4ÓÒùçÊŒÆô ¢*Š%Z‚/Ü>ëÉ×8™a¬Ê °“VØu3wñWI®^åjv¶¬yÊÜurz‰’R––£)ÝYOççzü_Ó—‚÷âYQñiÕ¾ä ñuÀ“ðSÄ»´‚zÞBÍ›¥­³Ù § 'LvjÚ»‹æÇL˜±I‰5ÛŒy.Ud8˜ÝÕíUÒ¡$xà³kï#¦€—mWƒ…„B½P£$³áÑ-ÐÑuÕÏÇØ˜Ñqn7³~WåºSE›e†ÕVÝŽŒƒ[¦{¡mzby95óYËm¾‹ºAaϳY‰Ë·¿+RüSíˆC¿»Râ9fVùb î'Åê¹5Ì‹|¤9®Ê¤(—9­"Jn‹L,ùòœ°+·æyûá*„}âm@ýñQBÕ­76Û$têÇ;LBÅ÷¿CfL8:Ž Š)&lnÚ!ºšñ®vu!³êô(Ÿµöw'MžãJÚ3ŒŒ%ÏvZqMäLÛrh-¨ICzTË‘÷ô"\Jtì A {ýZpòûøÈÊ¥qaSû†>¹m„Š”@ [:kDz†÷€L}Ùj™õáòDBÉÐÚ›,3—åÆŽ·†µ®\â~m­‚Ž–|7X—ÕTäŽ)Ä’½47+ê°Yƒ'x…:&êP—øÇϤÄÜ!‡Ð™# Y†Ü, Y;#¤}ú‰í…7>š{íȯs!ÇÂîY]7“‹öni±y^—{ 7ž2|píEþÕ>yÑšæòL¥Al¹_=qż#(pA¼¼®¼½lE/êÜnÒÞƒ5ÐÑè¥æ‚¶aÐÁðãþÆCv*áõ¼î½/ý¿ÜAÍG—-îŒ*«}¥;E°LÖ?ë1—ï¶O*áý$SNäšû£w‘Y7ÒD­÷†aP1Ãᛞgä'½K…aVqµ>a)éž—VS’àÞÖ…×d¾ì¯ì¢m…9Åçç,/î}ê«XWªV:aÙžµÑvг>lÒ_ÒPz¿„¹^õÞætü¬“ð}\Öa=Ÿ&EâI1ÏW~·<Æ?x®´H.íÙÖ}k2®V.÷¶[ù#ÿȤ(ÁûåØú=Šù:ú·§Håßé-Ï}œWì´ÇØ<30†÷øêFY^jÙs×@ÓʰLU}³ÖÝ*¦sÜ7핯ê³Î¼«ºöéÞ¾5^{9®3ÐJÞ-‹½†¤r„@j±¬µÁ+ —èÖ7éã£áfónv‹‘âûºOצãúNº=éìì²×ÿµZ%ø"ý(iêd2ÚƒKVéž¾cÔF@ÁáGË~[ ÖVµyRdhõ“kÑEwzrCÏÄß½>Ýžµd^ylî"‰ÏhÌT¦^ÿcžù¹Oö«{>!ƒóêJS› á—µÛÂas…©þ³{¨5ѺUçÛØ5<2Y•2¤C.í¶«½·ÒÙËù ±ÎÐNùKYð—CæÌ,pùª8Û€ÝXÄ“tžÉr ¼zÀšh ÎêÔÞ¾Ë?ò¿Æ7¡ÊÚÉNÜ•ýw¼êÒ©É"YÌÏ‘r „ìy,t[÷½3qî»éª×Ú—L†§î"ß)¦÷Ô053ßÉU8xÈñž?£6:tÅ@[^˜ø%쌟t@®ÚÙÄçKÔHDÞÈïð„ª¡™¢Ó•ñ?M­¹ p•*íÕ|3Fi3—ÚÌgxÝiœ2¬i#Ï¿…[¨â2úH­=Yé…ooà›Љ½½þžwƒeÙ÷ä!øxfÆÌ–&¶9ÓÎü7ÚN­(óÖ.¾µ|½]Bg݈Ôç]mu59ö\ªbû•x`L|…hýÚÓ0 {qRrØP ‚¨–]ãiÞH‹—^kµÏÁ;öÏbÇÁ:æ,[MUŒÌ“ƒyå¼Ôë*òÏz"´¥ž+{Û~Ɔµ7?)š×Ùž$Óæ¸,âüô ›?j¼jíBha6pû‚"›{ö5?ÐB?‡H'ŽD‰&Ìo8êfnA,ÂÍuÞé|ˆòZy°#0ˆ”Á°òÎx¨…¾kô0Gb$ûtGöýØÎ²OÅv7ûL¡æúQóÄÏ" ­¸§SÒï…>¥«?(74aûV·v¸#¶©©ã·¥Ý¨P;·0]3ØXÍ’œÊÊécS”læZy®Ä3Ž³Û›jYô^šÌ:üˆÿ«Òú¨mp:Ÿ×%HB§¿`¨ZÂ}]Ý®$%©ÓÍ70Q{ÕC„]¿CA#ÙÉ„-³µÍÿ \îYP'èõÞ²œNÜZ}’6nüý†âΊSf=Ÿ$ù“¨‘­²ürïÞÄ6ŽÊû4X¶¤ ^~ãkµï²TVõJõ Á!›œvSý¥éY R÷x­iyÛ:–¯$úRÚËíåCÇŠcYqG¢ë§¸÷"„Í_ÔÅ¿*öTt¬·aó®o8&,ïØU3Ÿ ¡ì? õ¯£ë=‹fe÷j›ÞhskÚG^ʤÙlLÐbTŒ¥ñw“ª|:o*Û è/8…? yª$„uFô%¬DR›OƲÒKï>m°y}¬„ò¯l8Þ½ŠAªËÞ=4ëÊú۱͗ endstream endobj 168 0 obj << /Length1 825 /Length2 1405 /Length3 0 /Length 1979 /Filter /FlateDecode >> stream xÚu’{8”iÇ)¯j–ÂFIrOé`ÎÍ ­sšBh™gfž3ϘH­SÄ´tuR®µ‰ÎEŠv”6‰Ê¹Ê±tÒû ÚwÛ뽞îïçû{îû÷ûÞ·-žèà‘DÁ1ê@&œUJ•@ÂÙڮŠHÄn ;2…H¦)$ @(¦œ±Ó+[ã'—A¼Ñ …†*G!ÂFAÌCÄ8âèöÞb®éãœ#þêÅÂRv°Ç°#9±0p`.öŸ\(ô‡D0°më_.$B„qÿßö~0‘‹¾w½QHˆ°]Ä,ܱˆAÁ Ç®pÌr³%DÌ”ÅtI¥PŽȘZ âÉÁZWX‰ K$ˆ%(ö ˆ–£W"ÅÞÝ`! Ò1@Ç#‡„ß#\îß’6*‘ošFÄh¡\ö7`¢LÉøc䟃0!DŒÅE»ÑÉÆ4y\¢R‰A8(ÿKü TŠ(Y$‰DÆ8ö}]­ûwR®®e¼ƒ(dGÀp¢º#uã?êØr©‹|ì¡bqÕ\{)0¬„Ù¸Ö& {Iò/§’+†K],Ýuú:+Sw†©S£vÍãù¾“öx6ƸFrNÌü3ÙR¼½¡)ÁbAÿðmexվć¹^ù¨Ž»ZãúÒáPí»¿ªxðŽd¯ž‘—ª1È^e9-’¥Çš§ iú¸QMí-é9ü©RÖ»ÖI D ð>×Ýár R;!= oÓ‰Þ 7Ê4‘²v˃¼ƒë?MHfXòžÞ·«>|;Ýù–sb>Ú»kdˆvO0¥*ÐÑœY Ê¿œ0™UU‰oá.rd°úϤ¼Øs¬29e}NÕÍ´z×Ù³×°Àvˆ¦4XžãWdÛ>@9[ÙwiÉSËËÐòn¸ä9w&Oòñ¢巪췸è½( ìѳögE¤Ü)+Î?mrb™T%:áÆÐÁ­óꉮ;µ~aÄëáý>›nrçà[yc¯MsLis”z˜VyM‡°墸mëhGúÚ4› µçë}¯ôåÎW¬×™˜>ëi¶—Jz%bfA©û¥zZ`i²ÏÁ†9šèhßF¤9uŸ“OlŠÙÖΖ§Çç´£„N?›†î+ÕÅ…I¢eSu–|¸ünÛóæÍÅ„gg§ÌµÙ˜X¸›Á‡ž§X™›]‘üùöÓ;{Ñ/ÆF"§SGâÒqaöoýUƒnç4VÓ"¹ù²w†¥×Î5ýyòeÿD>5KãîÎq :i¨ª{nÑ•vù‘÷ƒþ…Ý^ß…K×–¿ñzÍt+#>’Ï©1ñWh[oœyäEK{¬£C~å¬Y]c-Õ¾j?Mð.oêÍѲÖ{¶“Ž»X–¸%&¶G°?&Ì_¥´ºPÒ½lxbø%.kEYâ—y_EyXFÔ½!'UÓÁÖƒ¤ƒÁ©I¾eÖ<ž]>¥ôJç=³#Z¼ÝR²\fÐd¼î¤Á¯›ºŒ$T_O;¨¯¥V4ï¹åô¢ÅÜÜ$2I<‰ 0õ¬`'W\ÿO÷T¶44O_ùêBüüEC)ÆÐBàþ×éS”¡5‹J\Z͵ƒbœ©¢ÞÓ*¡öÝà†ÔŽy/-ê<û›$<Ö¥®¶Køéñ<~h+E-î¦Ú­x›žÐtIú*çjÿ.×SÙŽŸxÏžšÑ~ÃÒ¬ÜIÝq&£aµY¤—´qH[²AçùÏ‚Ø9îZ’Ìšx÷|ݽ,jÞsQ~½`¶0Ø´¿­«3§3Í®ùÝÞýÆŠ«ÛÔaÎ`‚ñÜgQurçrD[‹êä®ê'’­E|ócfá?/zSbVöÄ”ï(ï)JO-{tk_[ÈlWö±tï÷Ó'W»×ú´¹úa{œaßL³3jì~àÚü“òçbïâu5^ ÙYâÿÛºÁº endstream endobj 170 0 obj << /Length1 805 /Length2 1277 /Length3 0 /Length 1842 /Filter /FlateDecode >> stream xÚ}RiXSg¥¶ˆCÃRÁAPèe –ä&â  l ˜²¯…˜\ÈÅ@ra@ÊRöR(XYd¦¢Œ ²ª€4[ƒ@) ¨)- ¢©`{™±öyæ¹î9çý¾÷¼çý°¦,[Wxr [¤"D*æv8­‰ÅºŠ 6 nl¢ žHÆAÐ`#HA€åƒ–ùHÄìX´‚í™L5‰ À…9pŠ…šø^‚!ªnñ\I¶–‰ÄhÀz£ëíÉ ø)ŠAJø|_v<Xo:ûƒÌއù)ÿ§ ‚cy`íqaIüëªÂæÃš –à‹Ýa)ÄeÁ‡İùbh‹p!@,¡Þ°%€àkZæ@b1@z)ù ˜ƒš z9äÆŒï,æëV x4¾í Ùb$@‡mÌ…¶âKp_ x3¼o0ÃÓÍÿàÖ"75º€#ä‚X€H"l‘ˆ¢ ‘€T£æ¥$EÇÅãB=$Hã@ŒP¤¹±&G €goP›ˆ:øøÿAà¯@2€G^èYÉ&ü½] ) ÿ}Ãÿ&&laD$<Ã\„÷j‰ÁÒp‚”G¿í¿È?æáâ"”¦ÚÚ‘ÐM‘í º²áøïê8‘ vóI¢¡nã}$…8š !çPVÜ¥¬îgm´}ɶÿ¹±sf®7ïãÐHˆåxm*©Qåq3Ñ%šÛºWVÁºÝ’3¦HÛgóÓ3¹4¢ÿLÆåž5ˆ}à®Ë’mݰêQ,dÂÅŽR*òî¾óséûÆ:Ñáo…[•+Ö²)_Û-\˜oXï/„9*x iU×´|RD;Û«ÜQjj1‡|¡[¼[^) ð ]ß‘E1_÷Òxj4"‡L¡fÔ cå§^¬€U†æ—µJ÷’ØT¶c«¯_Isôã ¦‡¤­ý+¢ìsŤÑ݆|“˜ùgµ(Á³bëôú oS3øÒzG:®NÇX]Ü]µFËÊ¿½cÏLÜ “,Ëq[KŒH®Ö%g.0¯×DëûSö–`§Fnäuö·üã×ÌÕv›Sð»mÜ›w)u>˜ò\KwZ÷¤Ÿùô‡á“z„o%K­2+=ý‘Å’§Ž5EZðŠËIúh“„¦sÞbÞ'éáæs;" LÒHö_eÄÖZå-Ïõzê.z6,FSfîR™ØÌÚ¡s÷ê´Œ4¿x/ã4só·ŸœVM7œ¿wÉ,ŽèvÇ-(ÊÜU´XÖô¿÷ŠÂøŸ¼áíûç¡}Ê¿wæ”9¸™M @d+ãÌ’ SÿŽ·álHéÉ¥ÉÇ÷ë»µŽ«FJ;UŒ¤;æ»Ú›Â»™~bûAßÎóÏúÍ \É|0ö\E³Ÿ¥aÙf®±œ*ŽÐWë'Nt½™`“n­æïQEÍ´§5¶‡¦æŠÞoê - Ÿû_ÿ,pOÇw©3U‹~­¤PÏPçä–ü¥†8}g³’kL VÑZÙgå˜&;ÜQþUI_~2FÏha¿¶ ØeÕh`V$³3ü›Æá¢øå^P@ºži]–ŽÅã¦ýƮ٠¼L|ùJ—C4»ËˆÐ¦Xíðó✱è+Ì)7LÐ6÷O9xH5Óöb^­­UPµ§òFßÕ‰û±ã¼û€´“à•!¼4vçÙþ?6VL…æNàAV ¦™É6{ˆ>ˆÜò Àª>e•ÑiÌsýÓdKÊÓ’Ž„ê<ó*fiÿÒ‡b~Nï÷¼ï5.夥‡¹ÎNÂ}²g+±ªuçQ¢:¹”Î^ÍM(žÖsî)›Œ¬°R•Ž9ìƒÑyô3&.j’äqÃ@Uïêófrâ_Yçʲ¢i#ÃÝß5i1F§ Þ :wª’Q¡ŒrO+«_›]“ÝvºO*çw›|½w9—tÙ7ŠßwiÅû´öÜÔ+=#‚±kIòÄ¿ ”sð?ýbøÝt“bÖxÇm8ô…߯ÖnaX©ëÖ“/ヌ#‹{(Çš•=Õ…Ábù’k~õT#–«9Ë“±Õ_œ¿UÙõ–Â9R«áשl%PökÊg)–è¼ñ=eoö\yß`¢ZÑ­–¿—‘á¶~3*@º̼ùrö©Ì†®.[‰x|ÿ">}Íãà ¨qòfà>õèv£Z'?Ü0YÏwOüe–|x(ò|ngX”Îo¿¼sB endstream endobj 172 0 obj << /Length1 1473 /Length2 3265 /Length3 0 /Length 4027 /Filter /FlateDecode >> stream xÚu–y<~üÇÑ·‘›i”3ÇcH¹’ÛäÊmff̦†|}QnräÎr¦¹¯rFB”ZªUn]äÊo]¿ïôýýûgï÷óó~¿_ï÷gïÏc’âKmw‚ZŸ€')€Aê@MBAII]"IÂðzHZ†(•• ˆ$Ñ-uú„)ý˜©¿óý¢ „€•áPtÇ¢H@74‹(}Ooˆ÷ Á*?ýîþ¾¿YšèG/”¡•ÒKº𸠠;ÚƒçÙ!}Ð@™ï²þC‘>X\ÐÿÏmÑXŒ' (cŠvÇúûüI IH¥ÇàÐ@ÐOÖOKF»#°$”'ЉóCÿô[ãÝÑDFü°ß'Tƒ@0+O,ÊöóÂ~!3 ‹¢k³ùÕ!½Ayà„ÉŸJÐ>ôÑý·ôC¡ñ$ ü·íŽþé€ür ñîŽ>ÜCP2¶Ô3²1:þã  ÓxÁ‹Ç!0 ’HD@@0Ý‚CÀ@,]:ˆ&Ó›URÄHô ¯?é"Ѓ@|¿!8P ‰Ç¸‘(o4 ‡ö é`1ßü¤jŒ”ø}Ö»0¨ô¡é5~ûÀ`Ð/çŸÉ`pàFú7 c€Öýß@òe(þþ£¦ÆH‹ì ÙUE•‘0–)ÿ$ÿÇ`À Øÿ²ÿˆ o€’/’ˆÆÿ…ìÿpcLß f¯ÌHe,Îp/ÊŒ™»TýåÿOPè„A#Ù¥Wí ¶ 1(Þ¥€Qò®d šáô^üü}|~<]îX?_2è_b€ôt? íÞ'‹'Yùþï³ð}Á~ØàŸ¶%‰HðFÛbÝIžŒGL‘ôÛ&;€A 0ÝOÿüþæôß…ÕÑ!C`@ˆý'V©Ua‹»¢ü‰ôþH?LúÚÿ¶=°ô‹¾Uh`j‚€Òˆðª‰hþzG[$P6ÄNi½’h× #I=É ñ4Ù{ãÌèyW÷ á4Ädi䣉 "rK_’;²Â^\7¸Ib:ÝóZgE!¯oýS-æN8„VM»òšw9Éâ0·«Ãék¶[ÿ¨vBßU¾-Ünõ{g¯6ô¯òˆ_!Åiç´Î³Ä؉›!õÛ9òÄóÒý­ ­‡·Y"Tn Ì¥ ;FªœHxØb¹ÜŒSâË8ªUgÃü0WÚœ1àJ+ úldõÙÃf§kñÈ£Êí{…Ÿvæu­‹/¿ X %fÖšJ’1}k˜KÐ>/´7‚µATªh½–º¿ª+ÏNê⪱¶ú¡€æ½TWódÖŠ{§¸}ñáÐFŤÜR,å¶!ë»ãGæ½î,Óï)לêjÍ{·G_eÍr'±t(ûWBé lŠcµ"ŠW÷¼.SÀR¯éDZ¿çDdÍŠFÆ’Yï(EpßqMꥰ6È?‡uKžÛj{è:¤±‰ pìnÓ§PË,/ ´4Ñna³—:]½hy ™‘Ëa÷®Ý?×ÎÓÀ{óBEÃj‡}ÉV†Ì+Êì)oé`¢l£ ŸÞ˜ÂÆœD"͵Í6&$týЦ¥æÎ„ÔBVÝSg]yLmÈŒKUF\M^v„K"Ãažœˆ¨8·HŒú‚3¬, Tmßj…ÌöNkð©y„Çt—Oi–…qž2ò‚¸ªão*»ï.±hÂñ•%¨,~¸³¸7(»ù©¾®=>óÙ«šC*º"5 %rfå|-&<$„2iè/íu ßä½Ú·)’ìyQÛ$(dÍ[=wp‚òî‰|y{Ÿ67ØÈìjœYã>7™ /®GõVîÄÊ¥­&®lÌòEu¾TÊwa]|4 hQÇŸØÔ~Õñ­àåøçÑçcÕÇÿ?V‹ –¶_p-aå` ¶U–FÚS°™·ë³^š½©Wxíäõwõøœ¼í©çuýM-¼IzJKÝN²™=Þ<ÝB” n…ít5‰Ž+î$9 OÚY9ÊÆúR¬‚AÓÍLBئ¶Æ3‹Ì”ç¸C¤¾ö=H³xÔž$$2f+"¦³ÂS]µä8´t´9¶ëÞ'Ñgyæ’éšy€Î&±ÚqssqScv³ˆ2E2`œz*—Ãm_,‡(&$ Z_Š”+¼zs@#ã¥fÃG¸È3­Z—¬²bê6Ÿ`&$KÖ>d•ñ(±ê‹Ú^U=‘F  ²‡.GØ].áÚûMBã³ 0ùbÈéœÀUö€r©Â™}¯ùˆµ« g–¿ì3c³ýÈ·wG>7ý\íÓJÅÔÐÁ…»ÞæP a—JLGØÙàAÃñÛ߸ü¯¿Ly0ö’ÍïaJ®TzŇÍÖ¡ÖŒ&W´&—ÔJ€JºÉ̓‚P~öcŸ<öeÙ¾£y…’¸»B7§æCÞNÎ&^í{Ã\v~Í`ðXŽ{éï½­j7ÄvÞ–±Ì[ÒÞ©:Þ‚t7*žÆ®=<5%iñ—½kV±±V½õæ\s†]_ʳ*¶Q¼¬“[þ S§9/©,}Žx›¸,x@VR}´™4,ãîü%¿T†mÁÆ îi:z_O¡¾ÄêTO<˜vÞ–ÉúÙ€ïKÔ¸FÃ$›’AY8"Ë,k#!ðºô…¿]Ýí¥Eä. g%4¢X5¡`±®N;îuÎtx%™}i{¡÷¹Ÿ)²P^¿£bÍ:ÝyBi¿'+š}z€êòÄ¥³ŽÝ;åyq{¹¶~¤@18–ù”Þøz¦AŒ¼“ÓÀælpÁäF›«ù£k)ZA3óñüê,ÈÕôrkÄn‹æg_QÝõÔv;·dòq»rÏ‚Ò;]ŽA¢çž¡(× Ÿ6>Ÿ GÕ¾, ù±!T­×läÖKf„äx¸fŒŽ\9&<Â]%ÍwèÖÓ°5½½)HᯀXÙ¨Ä5ˆf€ Fþ¼ðd´š¡"åÁ§‰Ê¾Ëøolƒcƒ¡‰½WWÐ5¼“Ó•!£ ìLÑ™*b5qº‘õ¸›k¯¡žØ¹´qÄŽø®ßwIyÕñÞÎû¨†ˆUCÓ`‘Fù+9ÙÅ~Ôíêû*+ÀšQáÏF8÷Oa‹¶ ½§Ó ¼b -ÁÔQ’v†ë,s*¶ñ‘+§6ùs¿ª·¨ª6ÛóúŸ˜öýÊ©¶ã" !¢m ËÒàÈ;¯Ë’=¯?/¸D…3 ¸’UÖÇ„´£5òoÌ{âÞ(` ‚íÝ8nžÉÃ0FÈ’“ù¦ð;úf ~óò'ã¡ÃµnÔ%•®«Õ\®™hBE”8ñÚô\qôR9æQ*\Gx«|~SS„åb`«'§'ú½áäå‚kƒ§^’ž{iï_M ŽçâiÂh–Gâ¶^ x£rý_®dÕ¾\Z½0!@å¬ùà§4ÖºÜ$ÉÕ/;8! yy£H {àVµ®àÓ£H¸Y×Ç3×?,¾Ýsˆ"%ÐÑys‹ö,”:K9ÌfÙ;'·á?ç“Ö´vô›Ù°á Ñá.7Í ˆXx ë·?óUB#‰"†;9ÑÞS’mi)áÅúÄ>{çØi‰¸!µa%¡pÊæyû}±¯ÚYM‚×,®Ks¼O®=ÿ*9:+5Ø’Ä;°}ðDFeDÅÈÍ[/Öƒ6ì±F\>œ¬2 ÓòbC|­êB0…äSS×ôý+·²e4ì˜ïQ±à¨ÄàláÍ7 žà0En)ü_†=|ŒŽEUÚQiØó"µÄ©ß­¿ùúÁWJÈ«lñGõ<ïÎäõNºÇ\˜ð¶/{@äQµlP}.3B<äd󓨽2}#¨úƒ2gðb#7n¨ÒÏ¡ûNéõŽƒ!+Uîwáì-”á¿&½ÀáÆuE/ Ul/òFçÅ.Òbweº¤õñXO_ÉK¼‡{}ßî‡²Ž‚–­Q¢1>Oƒu›ˆºÆ©äqÓwBéfƈ,îá\`—pCªøb(F°À7>¢rÅÆX……þŸÙ™_$f»/4ì”BnшËܬõU¼bÑ×êb¯ix»¿ríXû™®Ü·L^ â¼óÏ™ë‰ê°Ú çð;É๸aõ*]l.E¯RËI”³‰™ýs0çÎbs  _å{èsmÍgçH¡¹ëûº†„ü°û©pè'ÄëìS-åÔeçC9†óQþоcö,Æ]ž·&ÿ>úM¬C®&ðK ÿJÛ›q¤ÓÐO£ì“Ó™'Å/®™ª0’Û/uiZkàVÝý´+—(;äRmûr:icF2y*õ¬,ÐiÛ¢Ûu}‘ûLDÂiè(¯æŒs_ÀM^.ñ€)j 5KkB8³ßÏPÏùX:ÇaÝÚ^²5sxÓåÅ`X' MçøgÔÐ’š ü¢°ç„.•àk°Æ+6}¥xàýÆß&à„ix]{ñ åoð~}’ýÎ5ξîgí:J—hjç\¦S «éëê¤yc>•è4\W>M@wð± @§ÙBzì3˲ç•å’$dd—|§¡V^õëYÂÊ*¼GëR,ýlâè‘Öª¢PщþþtUþê)óV³TµDÎGñXy{Ñ'æuå9^‡O«gd߉`q)5 ñx“¼•ÎÇ|¼ßCñµÇÙs´dU_ÁËmÑ® ìÆÆCo«Êâ¶ŽôÇL½$6÷ñ bæ“ñÜósúMwæÿ¬>GS endstream endobj 174 0 obj << /Length1 1140 /Length2 2577 /Length3 0 /Length 3325 /Filter /FlateDecode >> stream xÚuSyçŸó>Ïûý¾Ïû¼ïW^ÖÙMÝGö­È$X©ØÀ!ÔP@KÁ%/oN10D&Y``p€Di"µ5QÀÀÌhóÇÙ™¶×FÅ62(m¥2ÐåB!„…_‘¸47®·%áÉR÷;Ž£þä‚A •YPbU˜%qd1Àxæ9‘èˆ ¥ Yÿa11ôÿóž Dðƒ%Ñ~gma š’D@|‡ ªâœ!ëà1D*ø÷ á@ "Îd*´á ŽD ~ãÜý ¬? ¤R”#†°Lm{tÈlP °v¶ÿ] À´îç}*$Á€þÏ~P?„ûݦ¹ßLд¶´t07Sý6Âo”% KÆA$€ÒÑ0 &”  ™‘Ž ¦ô a6«©A"ÃÌ#@ > àÉ® ééšöз‰Ð41$‚/ƒõa"ˆ‡át~å(ߌÿI¢6¸À@ 9 ¢aˆãZZLœB!ùwúJ…A DõÀÀ~¿Ô`ÊñÅP~PL€YüM‹Öøß÷"™2|™ þ¡€&C €ÿܪmhB$2 ±\Œ.2Ö0öðÍØšµë¦GÔÇZÙ†j“Ny5%êÀ Ý…á~ö9ÖAf‡pWÅžuî)oïŠP™[{r .7úM¦M¼É²iÄlA½¨åÃR”Æ‘·ÚôÎ&̧¹HñB³¡Ïxv}ŽÓ«×š¨¿ø¥–:±ß`ŠWøe3%à¦ùµ3›“½dwÁO½ð§ RÐY4w[¶/›cõv|±žNo;¯klPeSÂÞè4-™¼Hç=+RÎa¢Œ¯°ØÔ1Ã/Ã0ª)FŠìî«ëuynÛ· ©:ŒßGRGŠW Ÿï2olöùl"Å—è4à.Å4*Z™¶H|ÜËBU¶“ fadÚf¾/›-âgDq8f{4RUÃ}êÌýQ²óïäž2IÛwd4Э­%yHûJvjgr°á9ݧWðq™1.‡ÌÇ)_[nÖ´Yr[\m¡óúh3@ò™’ð†ÇÞ±ò­˜OW7Žú 5ø¸Lt«ô4=ꬴrðÌøÔZµGØVëS/õ¤Ñˆ9­òî>™%üó—ÉiÛ¤V£ó$ þ4â¯:kÐÃ/³<_+V2bŒóÙX½Ú㈠©’´f拈빼z|_è¢ã°OÃl<ºµ±n ßîM‰wAJð("äÁ®FýÒKõÚAû_»%°6’¾~›ÄÞÞQôQöü++ÞýŒTÜkhö†Â:æJ˜È~¥gðpeОà†09X+§`ò–Áè íyŽÇg?ÁÁ 3vÅuNÚGmðåwgñÿdØ”#ðVv‹k¦Ÿ[ðª?ÑÃ÷ Í³ÞËVѵˆÆñI™¶é»XI™•!í÷òR œ¿²–Z4¿¹3ögäTj0ü“Œ³îKÑÒï_¹¤}.?®ç}˜~c•!»É¿r¦®&x½Æ-ôdÏT"eÓ4åyI×ê9séˆaÑ#ËN‚ñkEÕƒÙ/µ×tn=b‹_•4ÐTÔãNn »f²÷4[ o§W‡À)±çbÏõrWÚ=¡g÷”%$™ét¿þ,à–ÁÊ%U™î²3ÌÔÐPvVyw*'“”;˸¬—_Òñ^l0‚ë¶é´ðò "¿‘(o‡âx,íîE†¾ŠGI”\|Çø¡þ›³§«\3$#‡ïµÂŠ0žs¦íø/}×)cX †Žô.Á -wUÜYÏO%¸ÔE­h]blKKu–£«…ïPñ;»•QpΑ§dÏ5ì‘rUeØM:µ7§Ó¥èÎ×åJ¯W1\qó÷P^tüÞÃ&ùU_*J÷øÔÝMj²õ»Qϧ?ð”!ÚŽÍO[VrO¿äÓ›rt¶×?˜‹WbguSWØ•3hf‘ðGô›,É/2WÛ1±¦‰Ã V,‹2•íYÑ ±2¸:â;…ÿ1mæ endstream endobj 12 0 obj << /Type /ObjStm /N 100 /First 861 /Length 4186 /Filter /FlateDecode >> stream xÚí[ësÛ6ÿ®¿ß.™Œ„÷ƒ7ÎÄqœ¦‰_ì¦Íµ-Ó/z•¢»ýí‚i[²s¯¹I` îow±X`!Aá$²„k"DD¸"R8‘‘ ÜqxA ‡'–3"qX‘(b=) ç{.„$Ò.MD¤†±Œ# Æ7øƶð^)\i¢ _e‰`JÀw`|Å{F–Ì-á dhOí <áÓÚ¡"F #B»#Â1 Ú; ÂÀ§Œ¯-<­î ÐÝ „K¨´HdÐÞÏB{k¡HwÖí"à‡’Xe QAœ§•=gñø¯¼R”Œn)ý"ho€èª UÀd>5ðŒ(œäŒfÁ{œI¢ ËPÍ`(Î ÑœA_‡O`$ (Óã8²œhÈAFŽ5ŠX§Q@;âx„5G G<€œ H«8¾9k1#‰sFÐ+Â6ÂJl#AS’o‘º¹"’ji”5È:aJ@!aŽJÀ|[0#ƒÌ ¡ºÈd£rÀ×à/ª 4FÅÔH?"UˆÄZ¬ƒopg°o„ê‡$iYhàU‚¯"\d‹´Æ×Ø–9à茎#kÉnrõßø‘P¹qt-ð›~$…ß4ØËË8¨ôGÚ¬ïtXm•î}÷]žÝ,BOâQÒ£/æ³<™åK"aÖ½ïÑ÷Ér¾Ê†É¦ ¯8N.Óø`~M~cP¡#=¨’Š\ô©£dРøÖßï?pƒ’ï¾#ô¾«ð dAEt•ÕÄ”Y¶­jA¸edUYÀÀÊ|„rñyø=ÉæÃÓ$'¿–Ã#BÏ’ëœ|ªhhÉÍJõ­`îKb´E¢} žÔŒäÓ.0‚=šØÒ1ñØJÖŽf±PÛØÖ€èØQ5‡eDT¼ó ì¶Ú*0ùî±´Rò-¾D"ò5…¨C¤¡‚¬¹òeÍ‹}ªM °:~3+Ó"ÄÜЀ»$½/h»ZïZº;AwÁ ˜" Ó13‚Y_³bOøjK¹eôÈðCÂ[Åß)òšoû‚Ó›à”|dpíˆZ­Ø¾ ܳ?ˆ³4Ÿ$äÉU:Ze ?Ÿ%_‹Ë«§ð½,‰ót>;ŒsxøWðÚÀƒRDÜAƒãùeç;€u¹&yòz ÔÇ£tø™˜¸>xãŒE}.úàfþ –øqž/þJéׯ_)¶žúÖƒy6zŠTÒÃäK:LÞ¿:Ü<Þ³<Šî%ŽYH£Ã¢65í×wÿH†Å—^OÁ鑟Þò´Ý_~kN¿:yK^çË|9ÌÒENÜÀòv9Â6Yð15·Ï˜ø cÙgk?Ô?õúø„œÀ§N‹O]¥ C‹Éj”ÎÈÂà]Ü“$ºÞ¤Ùpi±Gú¿ÏY.kVöHɨiT1ªç^öT&?ÿUTÛ“Ân¶ÃI “µ=2²´[Î4ì‘5`Ta¿tTô5ETØ¿3 üßH׊ >v1ž^ÓŽc×4aYbÀ—…c àöûgM;NL±îSå±ï H«Šªç¦=Šþ#dFÁ€W#”õ4a˜µÒ %Lo Dà=!ÐêYY#dVÅÀ6¬!pÿ4‘رȀœ(X„bÂQ½HMQ_åqÄÎT½±cr˜„¬YìEÁdùÑ6‘ò2®°®Ÿtª5yhAòs}F«<*ݧ?ôý´muÖÖ¬È$aôܵå;ã$øcñâ‡$¡húÂÅ»¾à¶0HÞI$} Üéã•ÁŠÊ~*üO“ ÇêuOÒáóÙÜE0Y§y2ý³ üÛò[J³û«jZc!­‹kZ±ÒŠP_à !­œ5h­ìm;™zM¦nÐixä=»B*á¾®û¬o_؇í¶‚œ›Ç8î¹3®ôˆ±1.ø6ŠÝB¿Bìî¿S€{cÚ:‡ãB~CLá¡\ooÚ·µJ˜ í¸¿å"ºu2¶Ël_°Uì=+Ù£€ c ­g `;/'<ôVÜÖJ)¿!ØðÔ¸ìíH~Ó’`¹þÿßÿÍ¿Ÿ@ÂZ <­µO#M±§†§²Ü?5zþðìJÎà5UëÓmíÚRk(¦º ÛTL ïƒBªÊ˜Â÷w;6ßKð–ñ¶§Fºý˜Ê'?«`ÕÄ„×0Ñ‹Ž^EWUød`‡à,º¥¸;7× Ž; 0 ïÂxè¶Zܹ€'êf¼ÃŠÛˆEþ‰÷Z…mÌ3‡wfñʰ`ÐH±ÂÀ$Õj+)c|’x7L ÷Hx£·I'}R%êþIkÑ亸óÉßâ]jÅŠ7x¿®%ç@…ð–+¶Æ®› Ö7üÍ×cµüñe±•õ;¼ª‹Dù È~sàET‰lSTxÌ¥NfÅŠIù«Ó0q”)¨S¸mŽ´ßãýl“Bã½q©ýnPI˜Bù~¨» ¶Lܨb¢á6Ô +\TÐý¢˜¤Cç͉ŠI¢°¼Ð ÆÞû8¢Üþz¤¼úä"?…-LoLű«ÿùÓ9£ƒ¶ÕÆz_£ø‡£9î8ŽHÿûpµ>¬ò&šAƒ…G5h‚î¹ ü¯³‹Ž:u;GƒÒš£Â‡¼Ûÿ•†èT¨ƒ IÔGŸcê ˜8˜ôU+ÿƒпâȦ8guE<Àà1‹þwäø¤Oû†9êãIXPëÄüï#ÇŠuÈËÊÔsAßÕá ,WíÊsëpo+ÃAÃ8‡FÃÅ‚~mŠsÎòÖ×}ʼ+óÕûºOH¨Þ•qTÄ’ ¼¤"Uz§ßŸuúû">žQŽÔœ`Íþ=_Gž”`[‘ª0àOPá !ŽQ%/BÁÖaˆ RFœªLBú¶ut«ähÑÂveÔ«â‹(UB•Q¤0DFªBlÕ©vUF j|Èó Rµêðßôcéò0•’¨(w.j QUÑ&Õ´ 5,]9bUM¥(>˜µ¥(½)˜^©ê]Š‚'v·…47åÿ!ÍÇ i6å~ÁÌP†÷`ú…Ø?÷ ]ÊÒöuaè _‡.?Ývº\üýìôíßž½8>;ã,8v^Ÿ&÷é ^¢G ¾@}|Îyãø‹ë#i!:ΗMƒKbgx ñ„Ò#úо¦oèOô=¡§ôŒÆô‚ép>Æô’&4ùcO轚¯2:¢c:¾YŒ“Még:¡S:£s:Ÿ%tAI–Î/é«y9øÍè’.'ñrLsš³$¡ù×9]Ñ/ô+½¦7ôOúg’ÍŸèðr-ל»¸ùü×_N=7];352TÜ%Ef¦5·0ó„¾8™Ïî`à?Ú¸˜¬–ô‚yÉh¹+ Õ.,üøæýëŸß{Fí,4¥>*ô’ÝÃY¨nÕÇ3`ßÀçtÕDevAõ÷?¾;9{–,ÓYÞ5Ï`dždâqþ t ¬ù â>¬‘bˆ†i6\M¯&ÉuŒÛÌ‹^>ÿøþÙñéóã,ŽôþôTJü…0“"¢íêƒð\&Wé,Y6À¶“¾¾~y€`ºÀôa;ÝGçMàv¼©5eTCå\´##C4‹I<~žI2±HyÔNvèãɇ_N~}–å×i‡®Á’×ÌúãÄþÊfC8ª!œ««ÂT4ìd >œþôñð#™v!¸>qü;^b¸Ä}Øç˜x²ƒ)Mò¸\Œ’Å2E›:б4Âk}IF?Ç‹EL'ÉrIçÓd×FtœrºHi6ž·1e'còîÝÙÏGGÈ”¬'£¿Ï.ñž‡Ü_¸ ~àT lc2V”‹ ¬&Wi±P´€ÛɸüôË›OÜrØŽNÂtĶû.°“…;á³øb¿nZ}»“myszøã‡Ÿå×Éu·7ÜvâQ´”W›.íUÒu AŸ³[g£‹,~NòIr•¤£ Æ{GX…å$¹.žU»ºp‘¯óÓôr]ÈE¾9Ž/U}|¡îäKe¯€¢MrF«^†… t‘6 a)_çT‡û|ó;U),^¤¥F1 Õø²å ¬Þó½L—`ÖoÖÐ4oêÔN¦ýÕË—Ç/@§–7í:{‹>À£B:ì8ƒ;$"t¸îš$Zt*ÕÛ µÚÔ) Ö0›_V"βùײz‰.ùò3pdL/âl­J~ЋÕd’äô2À²¦3XêÓü†Nâ_Ði:“3]Mòt1¹¡óE2+;f¡%Yæ7K§ ]ÍRX[—ñ¤ÉÿzEú'\º¦0 endstream endobj 176 0 obj << /Length1 1626 /Length2 13947 /Length3 0 /Length 14790 /Filter /FlateDecode >> stream xÚ­veTÜ’-ÜÝÝÝÝÝ¡ƒ»4»w Npw îî,¸»„ Aßwgîuß¼?óæG¯Õ§d×®ÚuN7™*€IÌd ”9¸2±1³ò“*[Û›º¹¨ƒì•A|ŠLJ@skÒ;<•„3ÐÄÕä iâ ä'Õš“JÍHÙÙIÙøøøà©H%@Ž^ÎÖ–V®¤´êZt Œÿ²üBjêõŸžLkKRê/î@;£=ÐÁõâœI]­€¤Öv@R U9eRZe R ÐÙÄŽTÕÍÔÎÚŒTÑÚ èà¤#µ9“Úýã@jr0·þ«5æ,1RRG ™õGÐÓ èø—‹‘ÔèloíâòñÔÚ…ÔÒÙÄÁõc® Rk3;7ó¿|Ø-@rt}DØø>ÀTA.®.fÎÖŽ®¤UU%¥ÿÁÓÕÊÄõ¯Ú.ÖnRÅG¤9ÈÌí¯–þö}À|x]M¬\H]ž®Õ2’š[»8Ú™x}Ôþst¶þ›†›‹µƒå¿0’:-MœÍí€..0ØMç_}’þ—îMí¼þÎýõOÖ®.@; fx6öšf®µ-­àYþÚ9 )ë?ìænŽÿés:ÿ= Ú¿v†îƒ„‰9ÈÁ΋ÔhÏ¢ rý(IJû?S™ùOäÿ‰ÿWþ_‘÷ÿOÜ×è¿\âÿßûüïÐÒnvvÊ&ö ð7†ôã‘1q ýxgHIÿzhÜìÿ¯{k;¯ÿWÒ¿GkÿÁVdgþï>9W“‘ˆ9X~ÈÂÊÌú£µ‹´µ'Ð\ÕÚÕÌŠÔÂÄîc^Û5ÌÎvÖÀ]ÿ))+ë¿ù>[Y›Ù:ü%×?\@ó§ÿ!ÕßäY$45t%þ›Çõï@Õ%pýìåøÁí?ZQ™ÿóðŒ¸8ȓԇ‰›—”‰ƒ“íãî}âãfõûoJþ Äö¯³’‰«³µ'©ÞG߬lwÿŸ þ FÊÁ dþ×Ú\MÌ?6ퟆ¿ÜfnÎÎÿ}ù?ºþÏóß;zÍàW—@f!6éY®u8߆'%õú{Ù ‡CK?Ö€zÒ#¶ù*_jC™›¦ùßÚ¼~œ:¾îËÓŒöbÛÑô|^æúQÐõ mPwð0³–"eœiÅø\-*nAér³jìLª©–¼ÀMwp8Ã^=ÐR¸bRÞ;"û›¥5Äcu¢6¡×žžQ'?ÜÓ Ž õÜ@÷í0äÆÃQ ˜àø§ž’¥¸z;ÿn4{ƒ~rçqÓssÔ•_•`N4onÏT²¨Þ Èb`¨ÖfÞùQ[sk¯”ªl#n_"©æV{<_/ãÕ28øƒ¬1!“¬úI#¡÷!¶Ù*|ìð~–‡•‹¥Zž£ª®•6Ò²#òŒ‰ªLÁ“3aÌ[ˆ+u¦(¨ÞÔŸKùEØ4ó Øõ»ïœ_<ŒïJ'Ó{å:hÅf­X»Bö†$Vª©cÙ wŠ& <=—_1oÍ›özsÔt$2Fô·@bݘv\õ¶)?Îhñ=yáËæ7~¦šÙã58/xœiëµ%ÌŒƒÍ¯Ú¿-«˜6Þ…Þ—¿à1Oü'\,žSd¸ y“F‘V²ݱ>K U€Ô'èù,r‘êñ¢':)´ÀÌò5÷á l`ç‚ïXSޤ¥ç]¤¥Ÿ/2÷aÉ4л>+qªX/¡§æýüìä&”ÕE8¤åJPê4;¿Ù¤â K”u~hËÜ) ÚêË Jõ»©Ê*Ð £+¶';òó3¡öÜ´v"ƒè¼º¨µ,‡áœáFBºÝìûœ¬WË`Ý›…{isI|XæJM9#cýy'Ô;˜§û¾/?™y >¹&东vX Âõ;ôL ¯.:?o݃¼éÆýNlöÍN¨Ý²à‘AœØ®d‘,iÈ:¹‰¶¢5z³èeqL«·Ï,ùÝx§Ö|³qÉÎÀo§=sšUû,„­Ø6¢z0xðiåõãÌbµ{¢$æ® „š$Ð}½(ãðH²!¡¯s~Xçmí¬±œ¸ä:–t“ÝIðyq܃`·áÒÀAÙÁ:²¡z¯zO Kɯï{ý¸=†Ø[Eæ~‰LÆ·Ó‚ši¬ïiV®òÓ¥ „ráÞO+מÐÝÑ'èwáe¦«„ªûõ͵ž2Ó`m1Jü––ß°û¬Û ÀŽ I/‘s]wÙû7•T/Ì&˜ÍpW箣ÞqÐl]Ôu’öÑÜÞV–¹É£^ü‘²£ËÅÍÛëcê”Æa;Ta‰õòK1¯Àc;ñÖ°±îÃ&¼v…ô¼l28ùr² ¨Õœò„èš0´­ozï ò“o á\iíÎdÕÐÞÉÃ*úfÚE@BŽ]Úož¦ý‰â sS1@Ý yVl3[ž’Îç·.3 Ô«ßKÀ‰Ï¸©×{^­4¨ø;üàØz}!V¬q£7fÌÁ®åɹr—º€Ãáj\=1,¯™jh@â`LZCd]5KöÍ箄æ~Ç%e<·øk53¢ˆw{Ö0­%¦;ú§=›âæÄš¬ŸÐowvåLK‘Âß{k?5ZMÞ^þ†j¬zÏ¿–>Öª¸ä¶0¸R^2+„¥‚c)Ú‡~»ÑJ©·çÿD”2XPY¢Ù¿&ÈšÛË®ÁBðˆlxï½K0÷Äà­M‚{ô)/(ºY«€Ô™£S¬ÓÐÕ>Wxm‡@ äv@Ád!Y@ Ësãì‚©¦1=[>övÅ6F^xy›_–Õ)ISÚ™ ¤JûÅ-Ä ËAR¶LFTÔMaÀ‘iÂ’¯<æŒëáB´ÐÆ¿–¢¡M‹èá,I]t"ðüñ]óVƒõ¶°Ùñb†Ïö«mgÄ­.É‚+;¸)- ê¡Þ­É»UoSmòÞ"ã)mKæÚÔx©"Š7]í'Û#¡4òaTM&3”Ä®lz}4ýJ‘¨¦h>Ñ©Þ'‘qc2yä»Ó¦N0ÞßË\¾V«!9ãi>"×Ä'_¤ÖˆçøŽNVŠ ‰LާFŒ<;› WÆÛGέsF„àåËX! !cj< ÕO:6#¬\¾ЪqbL†Æ5¬uGòÛïùƒx„ýnqtJä{±ÅùÄ»ƒ¿ä%Ëíu}ÿÞå*R©½ÇDü©+7Â+C³Åt€E«¹wRƒ}î[–9/ØÐ„Õ}–t^Ò«Ðø,.%kCášk{Aî¹c«µBÝZ”«ªÔ-ªƒ Ï:7,Á¨½%ï}6ÀÒù½*‰ ÔÀ#ué°‚g÷³&;ÅnË‚f°p#Gûd)çÂy†rÖ5£çÌ?5¤§Áupžœ?I#DÓû³A%A]ÿ$”<_Ó ‰Cºö‘¨4=]ÌLØj¿ª0c}U÷é€.Ê·«X,ÒžqÜ¥90T£íHŽò¦¡ ’MrbióÓþ11K.:ù*%§²¥ëV¦‰S”˜¼{kÇÉaÞåDk×D 3ßò¶Ý ï×1•ß-¾~YÁä³Çá¼`ž&ä‹ÙòEïÏõtñ2>!¬à–MiíÀPÝ+!k±Pe3ì3*Uc6üãÐN£+W³d§vr7ÉØÏ7ÐuòçW®ô¼2WùvF-\žiLhn† ·½[çÍ;wëUµì0¼vKŸ–ÁÓÂiÈò2ævû*ïYƒ[ÑåfF6£}Èë¼QK¶¨‚öWðš0IS’cüñYË8ù†Ë£¤é;Ò³Rœ ˜!oƈQô³» ¥%¹y e¥€.öÂм¡gÏKä>´äöÐËd¥_‘Dˆ© ×ù¿NAsô ¿ Ñ–º‰6ˆGžTÓ8µ`˜‹æÏév $eªOÊ™DEé€&šµ}ÇôCÈËs¬Ø?ólY«ÁfeE!Ídu‘»×%›ž¸¸t; àì‰̇¤Ñ®>ƒ&+$B4}ÃG!7{T¬Ú¨˜Ï‹Çẏ™Z¬°ƒæ —·±À}™µÕòlÛC(&аÔYñ°ÏqÄÉe ÓjÐm Ã^ëÏÔ< oû£xÃ>/ÎG­Ã$ŒrüúìïQJbUµ9伌¡êÌI*ÝJÆXGßÎ!÷ór˜ÊÜ”<¼¡E¤Fý–¿þ9•¦Cãª?3 vÈUPM\2dr­tSüÃLJŒÇ›å|rN4i7î1ܹv%~Ìl÷ñ´]oßÈ"ÄOÍtý„jÕuªœ,{.”ÔNŒÆdÖržª8´ìõp Tí‰Áx°òí×_ò)´hk5'æ$کɽzÞM úíÍœ +ùæÉ= LìObí(¿åžˆÀ¿LÞ0ËF‰ ÞÍÇH(TM»†´=Z¦•âTW—£hÆ».ú—3hdå~³ÝžXj·“+’DŠåm}Ó»sÀ[ò€±¦K1šÚï­ɲßnNQwƒGÌŒ0ï‹w‚PJ~¦¯ôY-V>4öÍ×¼¥ilQa¤>Xú„CsÚ3Û(.ûjJ7©éÄá*îr-~oÄìà ‡E#‡p'é‰[…‹¬bô,¬e/ìÍ®x[¾~ .X.S{³³‘j ¶âdb¢sK.SzÉ<@ÏóÙ…Ç»önßfîg"xȶ]:$áaïƒ3{¿l“ÇX|-Ê«%]=aÃè%ÒuÙ&§êc¨m[饓êaìTtÍI‘ ¹ÿI2f’W°Ê‚Ø]„‡(©ï ˜DµV+,O:r£Ø€µÿ0´è¤œX°‰mš[¬ý=Õ—åªY&WQIÂ*ŽB?ÏÇt;Ê ½Ù7 ¹w%°AoAR ÷Ù)wšð8„I]Ì6AQ¨žèwÛ÷M÷°õº3…ÐZ6¸y=xs$ïÅr$ÓΩ_›ˆâÚ¶Žl-UbR‚{¸¡ï¡Ÿ¹¨2¬V¯‰ÞR?“M)’B;ÙíkÃz¼PÃ"WÇ8´©N´êy[V·3º“ Kàûòv¦‰úÔ€³£fo˜+,k2*u1°_›-M^gvó+SáÔÝ'Úc“óª·…Tú&Ÿê¿öË/Ý–T²ÇDÎ"ŒKuT§õ¶è§ý,ÿ"¨siÍ”ë1LTÁÙÎ@ù¾šKqüÐÄŸ^é_É/âfÔŠ%nÛÄ>aŠÚ&b<5¢Pð rýÖ>R黊H@_N ô^€ñ\|ix¹a›A›¡¶ €Ù6·2¿2¸A‰êÛ°Ÿ”½Þø["êQ@©/ôfËM2Ž ëº&èv§²ÒN–Ú!GÄ~ªå¿aò /?›ÚÂFmبј֕ør8âXmç.ÞN^úÍ>÷qy“›q›õ;a½8mÊC>43ŒÔƒÎWÈ”yBœëÄë¸ ­‹eD÷|ƒ¤ÛPwâ…$"…„´ÍÊœ"ºÖÔû­IW¸ÒpÀð¤Q¹Þáa^‡³\<©•!Ô6¹.³#+QgÙOÛ²¿Êè½òf;âo6­)º…eˆtQV³ítëçíjâ:_x˜¡˜¢7qnè+Ì5^íKˆOÒÊ u ýîfÚxˆDîh¾s¡æ¢:Õ…>Gÿv‘-IhøâK¿Ñ‚[ïdBpo7öçt»S×$š·F]Á4ÚÃØ`t“3l–ZâW|‹q¸{¯g}–M¬©IäÌ6÷þ倽â¬q1Ä Ôør%3á¶ÈÍuáW•Þ*aIªµ·î”+:!ñ¦[xÏ‹2½ aU æÃHS§¶ùÍ)Ð-æòW@€\D½¸°Ôäªø‰?ØÂ™ÎUÎ ÿJ—ÄrÁéZb<œlM—sEþÖ‰wP~žÜȽ%wi=Sþ9«•0(‚Ö½Þåí«õ­nm|Fi9'#¬¾ÑüÈïp 4aA1D"ö–i”c¤Š¤»ðƒ6}S1›B8(¥C^:æ;']ÉSÅ[ Ò›Ê?>«nZtþøL¨™£Kî=ãÛb$‘çˆ{‡8wæ¤J9­’{KH$°AXÁ$ÕÖ­ËGo±` ó‰õ€ÆOïñÔ¤Gë[m˜° Íš?‡ ŠPm…/&è27ÀÂ#]G·^†‡ ü4ƒo9*Y4 þ­ cuû¥è á4âS”„ Læ­QŸ>ý‹e×FY´ÊÖŸ¢÷ªïMéPäq®u tDSÁß95™¿¶^ÅXôôÈ 5+ÛÊf«Ò)ûYj4jaUÖ^ œS`¬5£ŠJþ;/ §C3nj.åÙøƒX“Ý˵2’1 Îá² iÖâ(FgÂßOmÒàD U~]¯>Ú„_d+ô+‹pŽtö˜—W íi6\’–óÁw¡¡ÚŸªmdãTx0}~ÑÃå z„WL™ìùCm(ÿ Ó(ïEÓ%V±©÷Uêw·P824yÔyGV÷Ûé0V‹™¶†­BÖH+ì‹_!®,ý —«ü8vnïô#j]}X|ë·tˆ…Äø‘ɹ¯räÁ¤ŒÐ« !Er vËnã™lÏum z3Õßö(­ÞBVbéªD—óÓr.NƧΉÄ‚¬ßúéóOͯ¡c~9⹳Ėˆ$¬œ-’QmM¶ƒÖ âPTÖOE®êœÅ` ?f”H‡Ç l—{_­i]<ô`‚uÍx+´W1.¤YYq–´·9lÿJÒü¡°ÈAœÑFÆ}™Vò¨o7æ¥UôE*‹8»Tg#+6OoÂ-œ½.ÕwWˆï;Ø9wâkžî¯šì·»¼J(·5E°Õ ô!É.¶ÇŠõNu\áæo³5†8†e~ _ìñ Vc•"ع4;cÈx£ (N>ƒw'f$&ä± ÷/‘sÁŸ ”F÷ç|é¼X–fï±ÕK¾Boã6 æjøeâŠôLÆxä¾?ž#1NwÝrÆpm1¦[â‰ÀÝņ„«+‡‘K®ez»­ÔÌ$7¤¿ö^JE“¯ù0è—0ܦ¡>D¦öåàYÍX¯ÂKvé€`JUÿþb†½®œ—É'‹‡]«ö‹ß“ðº'WH|h~.Í3¸<ÿùyÙ‹\ƒƒìQŒcq˜Ãqý­Dœ•#°MÀô«õÔ’÷W:ˆgCdÇbT-A+¿´LØWâøÍä䲣ÊS£?‰f¾WŠÆï"u®GȨbþíP8Püìu9`)ÈkÑ‹ŸKæUqʼ ©’á=´L ”Á>ßÑ”þ†63³ˆ¨8}k9³.Ýìæ.“úÒüm‘2åÇ|[ßE‹àô9A¯×1Ïr쎠P‘.eÕ~éä^« Ë1ä cì³» Cƪç‚y°tÜA0ì1âÊ1þ¾̯{Øî+üã*X€<‹ì®ŒÑu&½R 2=¶¬™}Øަçö/€ögÍ­o*ºÐl… E"àìîr/K°žÇmC’²ßÔ? ÈrŠñ$‘Rdi‘Õ<úz‘-½QóR‰ } £¿Aþ˜MŸÎ)ÇWŸ³±ø¶Í¿>‰\ö(¢÷Ÿ§â2˜µá=1þ©¶ñ>8¨3³ŠhYm ãÙ–K™tý!É+qS²Ôa[>ŪúÒÁå®à†Vr[éËWÒ›ÜqÀ?wÒw ßé:_™ÐB1 iÄeýº£Ïu’ÿ‰ °×º»XCÍ«Ûc7*^ÙlO}Äs(Ôåzw¸Rëó”0aæ2 ½ÎoÐIûòä²XÖA»Eì0ȼDhgwhÝ“>ÄYê½ãçöÉ+…?úzˆ²o¦*+dJ|Øn·­òRàêà"„¾1X/â*}ßNOÈ¡ñ€F]5°Ïht^Bâ¦×‡Ÿöç ÞÏ9fãm©Œ“ Î£æ åÀÁ5L-íø¡‰c‹úB]—¢‡¾ ÒÐUX`ÛÄý L§ÕÓ—”ʳØ0R£„é–ÔZ"åj‡9†/é~¢¤E2…>¿’ËŒk†S“’ùÚÁýIÇs^i¦#jᆶþðH±­|þ&Š‘v¨/p\Ä„8 :'U‚Ä`/æQÃð'?Mùy¾i8¿M³m,Ü$hHE.9ºÎ>²è(^/â[Hþk=öŒ"ŠêsÑ¥~I °¸îqH¦"üÏôñ„u%ŠO¢Â»íY}'T°¢ðÅKËíh {`k9³¾ÁªÒ_oÊ /!Šš°µÐã$ˆ&úÌüëªÄíâ6cBÒT›QbkSì4õ% m5b§O2¿Þ¤/€WYµ¡nS2¸YpéÒZÄ4âž)N@—¤>«…{Zè”9æ Ð÷XØ„½ZÒ¬I§W»Æ×aõlpnQÒØYé#WùO³ß‘"¼ä4(׳˜E†ë˺~‘ÁºûûÏÓË–ˆÙCÕ“¦ÔPíEðûjEš¥cT·äó_,šDv NWRLŽ`6¤HŽð×rÛ¨³ m ¬÷wp*2mÚ‘ b׆Ë´/Ãé½™Põw]8,”æÛÅÕç”C¾Q¦ÇµƒcŸlϼ®S¢ÑáH—­os@\±Ãú$¾êûžVçe{8C<‰&Ä2Êe¡ Gú»ùiQÒ)§!?@Xð“ÿüÉ÷ ÌÿŒ«ñLlËdcá?éa°ŽRAqJr³ô„o?¯¤.\¼ ¼¼$jˆ•ê=Ôâ·÷ä V{ßîÑÔ ô|Õb„ï,*kO¥U% Ð:î2 ’$—§îMp-&dcAK/ÿ¤Ä5XÌ”¥.æ9žã÷v}ú}wÝ<©i¸åƒàvhq‰¦šàµùÉUÝ2`ÉΣãiCÙx«ê©?òý‡#1t@‘eÈ\¸éh¡†¥$uÍ©ŽwJj¸1Œ{+@þK½eçn Y¿}³ã€$<¯ ¹ÉíÇôq a‹™Ä…½‘Wè­Î ñúKç³üó3[§bÊâ·ê\ ذúI€ ŽÄæ9<éï“þDHh²ñXíl"lÕÔàÊÙÝüÍ;²÷'] •œqÏOOÉj†á/ܲ Üq)1dïmÓYï $BWèÊGUy_kBÀÊXêzN~u„˜Øùw+éh¬m-áØ[·(WLÉ"rÐfüÎMUp ÷|qKÕ$N¹£¸RüÑæØ¤6õ,¿+aÝ‘J!-ê¯PB™®%“åó»Å"ôOõùôä HÖÖä)®ÂŸ¦ ǘ>(éD+fRÈý XfôŸ‚HÇÍæøÍïí7!0u(Œ¥:#¨áÀ¼Æ¹TÂd›¯îvP¼›pßi©0wãIÀ¸mW»`O{à,ð‹D:Xw)Y´HÓ¹²³2‡Er®i§‚nÝ‘¨`«4V¹”ÃI4N]nâH1¸\ôfy¨l»c¿´‘¢³ë¿kö9æÞl3àÜ€uÐ2Õ ÉØ×‡Î + Çt”ãÁD§$pÑéV üHfÕ‹Ñ埘˜ú ÇA‚­u£Ï èÐÉ~ðO磆þVQ^ø.¶870èüü…Kf]ä‘j0¥Á>Ø–Dãí!l¸†%Œ,ÐuLŠÍKYÁ°.Êüªè‘&T&›3  Ý•{Ë߈$zMõÆ”_õÁ„f¿=J¡b HŠ—N®š6ØŸþÄk—pRÁÚ(ÃØ rY!|@÷HpnØé;Á Íl®£åJÌ÷¸¥BpÃæYyžÔ{låà  ùÑ‹$Vü1ù‰èŸ„õ®b}R(%Óô#é„×÷јêƒí*¢ÁÆ}**>ÇrÍ @Õ.éúKîÀ\H]œSÔ<‰üĹôv©¸ìgŸg=1™!ô´0¾“@+÷ø¥OgÆ0ÓP¹o Efø‡.%èòqÉ+G躭.ÁTe[M¶Xù +\õ(þmŠ¿y4³Ê:WJµGî›Å®ü ¯àôñ†K´6m )!›[ûUÖ1*ÄÅÞ~vÍBÅQ%ÕVÏIÒŠ6Ê¿áì‚©KÓª].Wß”µP7zÜ,Ⴥµž»?éÄO`5 U/Hüræ\Я%A³'ðlî†K_`iÊvï‘BûvcÖó™-“‡@ù¥Ø|¼É «Ä“CQSLßNbRÁÍt3~$kïCRæ>ÏOXmv0` åñþ,¹gEÒ/— |ô/ß/–Ì0_=¢h}/œ5¾ñüãd)ÂÎA»ÂZöÌf‘Í!ñ¥ŒYCmÎ y9óà^UÑt±PÞØƒàˆÒ õµök÷Ø}_´úV@*âNW½†ìøŠ—Yú5:Ô!¼$æš'‘œ3ÒhPxÞ#Âe+שaþO’j§áoúú9¨ýиZâ"æO“¨b%/s»ˆUÆíÎqû:Ï´Ö-Ÿ™UÆ]#±BAH’ gQè¢Ü¤ïK_ \?{{VD/ˆ7KÂ(L]úÉ~ßÂ8ù‰.ñSq#·™’U ž´9€ÐfÂä`'è_äšÃð™U¢4ÞO 2;ÆZxrÚ€„°Íð{5F¥à̹“A“{$êÙ¼SÚ9¯N"ƒnÖ-B=È3åQ%Ô!gÚL c¢!}Ÿ­ó{H¶ +ÿVÞ-i’—³Xs;ÌNRQôȰ­Ç-Á[&rcã¼.4M²ØÎÄÏÀ'~V„Ùó7ºè{NÇÈŵ†QF~92]% îµq)‘®Ê|¢²ÝýƒêTAT$ÿbóUzàà&=¤ú5Éã=×Q™F¬cóg—Ø ÷™¸jʆÇM–Ï_pü›F+ºúñ¢c)wBLCr/¾NT¨ô{˜!LFµDX£í9 £g9  }?TrdƒáõéQ®¥§”ŠÙÆslvËñ;µÑä\„-"óé¢E©Œ,b¸)æåØ<•èÖÀ§FÏ|ʹ‰¸žyi‰Túœ¼Q®15ß¶ç#9Ý^᣹èXu!ÃÈÄ3Èf!gQ3Zšd)¬`|\û9ÿæ;FµUíüÖÒÕ~êú* ‘ï9 ÊLçź{b„k×~Á¡ƒüñÛ³Xýïr«g3+%AI-â|—q`úN¶·Ø; †ãöω1èl¥ïš} G±²F°?(?¤Oü·K÷Š£;¼)r»…² bi¸?=0HÙR^WÜlYç]¶Ä9ãŒåB͠펞uôãs5[eF¼6YOôa^ C›;ùÐÐJã¡8¯V ¾¶ÇR:W‚ëS•ÆæâñR•¹VóÓ¯;mÙÀ«A‚0î¯oWÎ{jèGí›*¥v=M‘iT/§’¥F§ƒ-¢ëTp³q³ Å†‘‹ËÒí›d‚(-Ô=SØ”Ÿásq^¸¼Äç¨OõBâ“6vU%Õ=F3ÞÂ&œå'„Ö_e—Jc 3gѵ¥(ø2l|W8i¾ c€$ŽTpJÍ>fÂó@kÝÈ%Wsoñð‹ÉÈÿIIh(—¹£lúÊJIË èü“âM—sàìF+[öúŸÌ¡ýB¨ ž_ÓTZ¤¯Þù êèœ2Œ°ÆæmÌ6úìÄÞŽ-:Zøc‘è–¯`ô ¤&Ooº‰õZ–ÉxÔžs·µfιNH¦¨0(æ|'“%èëÞÓÞs,2ñTË hͯ‚Ñ9³PŒ†jì‚­øq›l"›IÍ.ž­GF@ié™iè߯¹†ôÈ_½ÝøÇa“¶Û¹ÀjÃjÝCs˜ÔxnØ4Vß}"H¼äªkK_ÉGÿüö}ž é–?Ó’rHN„(Î\×ɸëYiÜ¡àD‹sÉÿe¬ýsÉjPPM«&îÌj0šH¯·üOþv¼‘®åRFÿ+m¬ ÐÓ6Æv©bCJOKÚ`Ûâ½dþ£õ€ek<«—9ƒ}Î*ig]ׇCª´] ÌÖ]x6Z¸r[òH–²#ŠL¤ûÛÖ×Ò¨:Š\åív8¨–‰Æ;=]õø+*9¡6# Ïª¯tŒüšoÉùy—[·'N®yà-U‰ä ³œL–=à‹}«MJA-¤‘FÈ£}üºÄ± —J5[œô òR ^}ò‹Ì…;¾ðOõ·<žNòô\ºîº|œhó:šcÜù ZØ‘£$V °÷<&Eë¯*®Fv3eu‘«òý¢¡yã/«'KzFÙ\àNÉÆõœ4/Õ>ùæ~“–`…Uå–‰{éíl”JQ'ï·wI ±ü§˜±°åŠô„8:›ê~Ÿx«ˆÄ-åÅ–_ã­ ¿¹€©¡ž—¡élÏž‚VVöøL{©Døß¯ ÖÝ%ªhÐc•‘;ânq ò‡ éUv±\XQ Û{¹T0â/ì,Õõ«pð Ê×õ~äºZñRGU{(ž†'ò‡iþk ‰¾êC¿G¸°Îu,OQO£‰ƒoó™€kàŽTæ¤(tç@×ꉾp{[H:õ{#bkÇ+¢-Ÿˆ²÷pø¤W£¢È&ûÁ»a‘`žæT” ³Ø>©ilÿRó#꩞Š|tѨzÝ>ð£×îõ×¾¦¯L[ R9s  F꣜&…§ï‰õ=4âTðöDÞ“ªÜÐ}óÄ«r|4 Ð_bÌãºþÜ¥/ºó‰Ññ¨ªŠU©ÑN«ܨ7#ž‘%Væg ƒŠ¦¶»ûâ7±Ñ1"foìma¬œÑ‚¹ üÖ†] 5Ö½ó6ˆñ.;wcc’̆çuH"[Í~=1’û1½FG\zÉ83¼rÆ?@¯šÔÏ”²o LÒý¦æà"*(gÙ³`ƒ ¥ STBÍîÁJhcK¤šÈV÷‹/áú•$F V+®oÉ mÇ!­(LÀeÀ£}¿ð‡¹y¼…Él†Øe·ùÉ–ý«„I²HÔ?Òådoyv˜Ú÷_[Úa­^‘r¡3°CÕjªîW&åÊÇ ä3s¤j;¶»ÑVjª¾M©ÓÛG̱wÉþHŸÌâ˜Á•þÅí4¤Ø¸ã„Z(T°râ±S•Þ×m!¶]-fò¥î†3ÁCò‹ìR +šRçLŸ­nÚ7š'§Ãç8é’ÔtßN("0Âr=Öi7AÏN^9Õs%Ýörpü5®Ú¾>ˆ~Jkyª;Ç”\}ã1€£–°©´3zt·XýüÊÁ´êÁeÓ:ŸFĵšª¥ŠõãÂÎ>á=‹f_=FY\.8ÐÌF/e'ò…øÕQqÿÉ·Š.ÕòI*{Vø‚ºo à48UåA,gÆíå_oC*½Ï^Ju0èK”³¾w1˜ X4‘èI¢ž}•b5©Œƒ«iâ, ¹ýö ¥=(ˆÓoDdbü”()›fÅàïWäzÏfÐþد܇¨2žŒÌ²iÍUtÖ0(A¡ïq²±’ÙÓ²¬™ŠÆ¡¬ïñ‰ÌJ3ª“QªbÞçØ‰†-Þg-‰ØëÖ6õì×+ e³y8Šù*çÒ¦'‹è˜Z¼ ÕŽDàŸZyqÓóQ;àë¥5·™&/—@šöÇó©Ý}žêत¿¯Z1‘@¨?(¿/W^=KH%ƺ5`2G+ùE¡?EP xÅez¨â@3ÊAÔ®×½oé.b‘y\õĦ£‡+ºub\PIËšV÷ $ôÊC©äs4À ÷zÅ-ž2òíkï«bÁÁ„o}³y²Ý9hýé8§‚2m9k;¨%¡ÑÃçrÛãc:ëÓNAµÔ§›?ñôÒGG4C~”<¯¡(Éhõ“Ç)¿õcVËÒdnE)!¾yG¨#{É"G½]ThBU‹¥Ñ^‡—E?ó|2—r@¨žç2Ôã¯b2¬Þ/S™Bн93ú3¼Eíæ³¼ÖaÉH-›Ùj:e¹Ñ¬R¡XjRN ƒð"­,†ö9ñ!›uF‹ú! QôgúÞߠ"«is’­•±¢‡L>ñ%ÙÃmdý¹ÆŸC蟇âs·X Øö²ñ*[qïöŸÅ³ìú vØ”"#~-aÎt4CÌrx_@3u›A rI›-Diè"K"ÜŠ÷}Á±7ÎÜõ‘Š^×¥hûÒ#=½±¯& õIÐSdÚz –ÆTæC[£íõ‚›ð"9í«‰æ‡Å|¨ü”ê†ÊK×HJhŒð!lìt’èææ—DÕkVœ·S>Ö^xd˜ÏÍ#T%&{“º—½ îã¯ÁŒýl ßÀ·^ZCæÂQʑѩn‡»ëö$D9[{½'Úg)§È< s›U›»(¿´‹/RÁ¶Ê>=#¼Mç[šï튽~!>û†¨Yû.Ûà  OA¶Ãm$^'òäð±Y1µG–Lßo²²oƒžtùmËÀÑŸŽM:x"Ç<†³aSéY“§Õ5ó Ë”^Êgò´ XEa3mi5g’ãÂ*Ÿ‚Z²h%GÙH‰áåaeÎ_…Š 1‹®drû‹{hRÊïáW-}Jd*ž‚V:¼Ÿ2ÍrÓLØ›ëiØéš»I³õ÷~k•8¢Vä’ŸoBÁ³ÇŸÑ¼£.@ßsô=Šï¹ô… …ß© }“¯›Æ8š©ióÙ›/ï<¨ìjPÏÝ%[DÍÇ¢«²RB‡Z-=V%šù#)ON±É^CÒ\¦ódøW+{~[·<‡¤žzϲ›DYê`k²ðœÖæVït';9`<¶ÍÙ€û<ÜâÚôƒR’Cí±³!V*;&ŒC°‘/ÕòtQ¯fÜ]Ã~ÊLäQ·•ãºÊ¿Ð‹.óð;İ¡¯y滨&ÍËÝ&B:'Æ×æ[g¶ð.ŸÁóW,؊⩳êØï±’8Ÿr˜fàòû‘¦É#côÃñ~ŒÊŽŽ?tmŸüæË%“¶CÿŽïè·4tˆ/Fä’ee!ÖNÌ=z¾GüÕü§Eÿ榠ä3ÌŸ$ÍÙ–ìù¹“U²‰šwOç-È›³.D AÐ/¨ë(Ê}ó…Hãû:A+ÔøœÄ%Ëe ¹îúJ”Xk¬JïÂI -uÛ™–ÆNþ¾Zp[“†Ü¥Á’®Rº÷¬]O}º—ž•”9µþE¦cŸ)eµy9òÜǵõçÝRóV¶ïói«œ#ׄƪÑß4Y3MïèçY0#«‹WpÇ;TßÚ÷ÞßÊp®·±Ó¢ùìÕH'„¡TiCÚw‰C"â)«ÈƒIV¿›Ô„ Ïej1¾l`ŽV›1½[¥z‰ÿÔ[MѾ> îH ÜÆ3±Â‘…ÿôÊÍêegø×së³y—vT;ÖW%rjVðóË&Ü >_É;»¨ ZŠh9º¢ÅÒ&SAcÎÖÓZ?Uç¥ç„7>6äÝѲõf‰KÈ•)àWßIñèÝ6:b. #-µÊ+ì„»Ëj^øéPj(< ÔÊä­B/¾ïBeû ±÷èÞÿöbNP’•ÁœÂ¡{NË„q—(nÊÆØ*K²š7¾z¸O6s‚:“½¼°4%=¢ÛÝ:öõ5òpûg•,1ßô>6CÔ†0 _SI錘Cí7ª(öÌ"¶Ó­¸ìßU^(ÂÓêËåÎ[‹Kà•“;Åä?°hÜÏ– ¥”¹‘‹c›%osdökîjòuö¯2ÃV>Íð !³ý’ê$fØe:rœ ñS÷n¦s|–,¿õÔõ/—«¡x.ËðÐbw×›hôÁÎalðå]"íaØž„qQ¼l 0ÏKÝïzò újZèylî‡hÔÆ%n53-îá7“ÁÝ=jSï¡4£;mµR¾}©II˜(߈­F¾y§Ê,|ó%Š(kµ¸> ¦¹à›Ë•Œ)ewà?gòRx¤R•IÌÌ ëéÿ\Ýð©SÂp?Ðý÷sbä¸ýãz™Å„”oª"âÂ`?&â­TUÚ^]9Þš¼I Ø/¿ì-ä&s;Ç4év°Û³#ÌÚ˜>ÈY?;ûµo†¬Ö®qÅΣ9V¬Ma;•KŠ@ÅRÕF¹?^—Í|®%9,#T#ðæ´¿TŸwÀÌR‘JЙUWàùûËf¿¦§šíž¡9J†=ÑJRŸEÛŠK<Ÿý&°Uû<»OyG¨¯Ç4 ÐSLtk^ècTúhõ¦è¢ðœ÷*Þý¡«xŽô‡àöfC,±œ­Æ†3ËË]®÷ã>ÑâÎñýEêS(h¾«§¤}v“ç –.uÖè?¥±c¹ª‡­s*]M-OÌ{g[Æõ=ùºL[ïå¼…® ¸uÃ4 @. ji Ìpu6SÙl"$4›Ðe™€wÏÚÑÚj×’_ö™›,.è%öfÙB¨5\øêÌŸm:TQÂ;Oš-‚ˆŸË‹µ~´z†9Ū2Óu²8ºèSpŸëf µÕåm™”e´Ó†ÙnH “6µO‡Ê|—ЭwQ˜ …#ª”ÒJ’ªäçRø$±ZwX³ê?Þýa,&h°ÅŸ¤p4n¼”ñÖãßN2–ˆV¸Ö>Dv #päè}]=DÉ>aþ3—xe¨Ý ™_Ïß3èiÈŸëåÏ7ÀêÅÆxÇ_ÊitÞboý™rþð·¿hj,*);æÎª"¯F(7¹„on¯6Êz â™°°?{ñV‡7,³ù$ô¿ßÝ+¨¼˜ò‹(U‡[Êî4€¿)º5‚î;pL ŸÐÑn¾F,oü¡@|a"À{<ÓÚBLçà\?%¬hIZª¸ç¡³k§`LÜ¡T@îPs–<ÊÔç¸Û@X È·¯q®ñÍå[„Òìžõ”ƒQSlèSXž.­ûíV3˜òb•šføt5[U1¼P~ü8+ CUËšœÉ:­Ãæ“e¶MV8!¢Ódžÿã™q¾¢šoòÝ×-Šèð^ }é'ä–›››P9Ÿ€ì³#GnÉÖy!óŸUm%cÃ/¸;¿èËpœ:—ÐæïXÓ©f(‹Oð5âîÁOÏçl |ÍxI7YæK!}º«Tò)®™¼|ÐÅL£ÛÃþZb÷ `EÒ?Q}=^»†M ]¼¤Ô4R4à fn–!¥2¦¶Ï–Yå¤FØØÔÌ‘O°«>j´Ã ‹LfÄ/,þ-ós¨0—b–Çfûɧ6€oPj¥P¢Ÿï/je¾h$‘ŽI^a•r-—.ßnØs¥³ræ#&Ípv=Îñµ*ÙšîÍv8$? =f|dñ’‹ËÍ0ûÖV•Þ,¶ø‚´ê¨cxV;¬ Ôê\”)`ÏÒ“©ŠJɥĸ/NÈÀ?r5LOóTÉÛœƒ¿‹l-¦ b*šWÊ­½ š‹)Sb?mÆ?q>¹OÆHëÔ‚{éáçÑQ?•‡»Nè¶Ö#^¢‹î=HáS)éÉëëþcÒàÁ¨bÿÃ~Lð*/Â4¾Èí–³Š]ošÜÊ1 ;o¶JST6ùX“­Í¸ê ·Á‹aP‚ÆVë«Þ+þ#~ûÚq}ÇI …¸ÈFÄëËQˆ?"-«ˆ}Rèõ½¹#ã¢7'þÞþâ²Ü£ZuZëåe{ŽVŸkÓíN’Áôx'0~4ä󮃉F­x¯0ä^2ȱšäéÚM6î{×~}:®á)bÔ¼Jí€×¹©F‡à°¦:%BM™cÊP$rðÿ_Œ^ endstream endobj 179 0 obj << /Length1 1630 /Length2 18628 /Length3 0 /Length 19480 /Filter /FlateDecode >> stream xÚ¬·ctem·&»bsÇIŶŠmsǶmÛ¶í¤b³bÛ®¸¾zÞ·OŸçëþÓ}~ì1Ö=qM\óž{-rbe:!;#Sq;[g:&zFn€œ¥‘‹“’œ—,’©¹ ௜ Žœ\ÄÑÔÐÙÒÎVÔÐÙ” nj5503˜¸¸¸àÈ"vöŽ–æÎ*U%ujÚÿ”üc0òøÍ_O'Ks[ÅßWS ½©­ó_ˆÿkGeSS€³…)ÀÌh ‘WД’“PIÈ©$LmM # ¥1@ÖÒØÔÖÉ”`fçþû0¶³5±ü§4'ú¿XBNC€“½©±å_7SwcSûT´{SGK'§¿ÏK'€¹£¡­óß8Û,m.&ÿ$ðWnf÷¯„ìíþZØüÕýS°srv2v´´wüª *þï<- ÿ‰ídùW °3ûkibgìòOIÿÒý…ù«u6´´u8›º;ÿËÈ`béd4ôøû/˜½£å¿Òpq²´5ÿÏ hŽ¦æ†Ž&@S'§¿0±ÿéÎÖ ø_ª7´·züËÛî_Vÿ3Kg'S =óߘÆÎc›[ÚÂ1ü3+R¶fv&ÆËM\ìÿCçjêø¯Qý33Ô“04±³zLLÍàäìœÿ†Pýß±LÿßGòÅÿ-ÿ·ÐûÿFîåè¹Äÿ¯÷ù¿B‹»r†6àß;ðwÉÚþî€,àŸE4tüÿùÚX=þO^ÿÕZÝôßéþÀ¤œ ÿ¶EÈÖü/5ŒôŒÿZ:‰[º›š(X:[Ì {ö/¹ª­‰©#ÐÒÖô/·ÿj+€Ž‰‘ñ¿èT,,­mÿ!íß*S[“ÿZÁ_ºþ•?ƒ¼–œüMšÿÍ‚ý—¡ÂßApVñ°ÿ›Ûÿ¨æ‡Éÿ<ü#,lçð¢cbçÐ1s2ý½âbfõùß„üÓž:;Zº´ÿÖÍÈô¯êÿÇï?OºÿFÌÖØÎäŸÑQv6´5ù;mÿSðÚØÅÑñ/ÉÿZ«þó¿æÞÔÔÝÔnmÅΘ'Ø*=+ù+odJT{°Ÿ |$ľ¬I¥¸Ð¿Ö®Ï/=|—«Êà£.„¾y†û«ÃcùÜþóPúûÑX?&²/Õôºß‡”z e‹¢‹ƒæ(A¯ì[Æ…z´×Í’ì„;£ÚÑÞ”¢’^éÁL‹#ÌÍojR×Bt²g{D_ã´Æ8ŒnäfÔú¢ó ФÓßÏ”?ÇGG†ûî ñhrã`Éy ±|SΉ“= ›Œ¿ ß\9œª—³ÛÔkQ’TÝ<ñÞW\ˆÈžbwј2®XÍÿ0 ®Åɸ]‡…ÂÇ2'òÓMˆÌªHë5t¯H]¬²¯_6òs§[g­rÅZÂ7G­H¤“³m¡¨Q Jþ\ÊÒ M0‘TcäDÎPÔT‹â›å`mÀ ãGŒ¬÷¯LÞ,‰Ñërö!„áë©QIjȹP á³§‹a:v‹|tàeÔ´ ý~ý ý¦TÁ+°Ï‹ –ºÕŒ)\9mU½0² -ÞÛƒRç&s}@Îò††"¹eÓLÄ-•Gþàý¢×Ö§ÝÓ›.ÆømQÀ`öd°Y¦tÆ£iDS²÷ ¤\–?V.ß—5Eëâqɨn¸¹™V;êTg· /»S85«/’}?™‡ ð|ʹOá* Z:ñ-Ô=Òq1v¸UzôIŸÁœx&]«ÛàéÒŠÂÖ6k|)ˆ³‹3ZÝó“ý˜Þ„ySóK®rÛÌï°¢ ·?€õvuÍZŽÏÏ«Á =è!\þ véoñJÅÒœ/ѱoʰߜu…ÊÞH·(6²3®%PO…ES™æïQl‘Æ«pÏsuW±Þ~–ÍVœ´3•%Wæ‘ñ¦é«‘0!­Òö“l,‘Í­a³A¶ -×qopRC~vu²Ggz*T`Q´r=j ‹"=]«¿Ô AF²X‚š(aëçî+ B™äË­ûB´×]='ÊÓå×¼Š^³Ú²8éÛº[b²îE yÜÇm˜óXÑÀò_*"3þÙ[(³å¯Ä—ÓÍ=“ ÑyÀk?=»ß¯È[ ÕZ’ë A\ÌìOדÖá¤Ç¬¤³âá²;3a"ÛÔðÛ†]\5?»Ù– Úýd©—)>Ÿ¾ h:YüÝŸ£¦e‚ZÍøÐN\Ž­ ž6óe¨ëMbXæëôÄI¯Q‹ "R²ýQ&XJ¿KTùTáé¨RŸðÛs†ºÚj§8ÛÇŽmº*©†Y•‰ƒ§ðv³óSð-îÍMâ"«…`”¯ß‰ƒicóܧQ6l< Ÿvw5Še®ž† ˜”î»fȘ¥9h0).b‡ÄÏCætÝ4Çÿ=ƒrÒµÛî3ûÚe©ó]­S«¹h㼆œLmwœðÄe×ð;¥äàØ˜â“^PÅPuµø¬´<",kkÄÏv¾O®+K¢OÐxÉo¾/r$#ï4 ¤ÉÖ}Vó€NÆ’'lmEÎզƴ«£@—3é„ÛÆH¶†þ,Ý+]Ú+ùr\9S9y4G‡ ‡¼VO¹;îœ]²Å’Ç!ý™³ò°tc …œG:16Ú/ß-›Û×ãÓjŽ£_ZUØV–ì•3 {ïñjúðָ͘ïÇß'âs߆™ÎwÚ/Ü}õ)£° ²u;L î·áÃí'­Û˜¿È~wİ€µå“\^+ÛÃGô'PÈpÕ:"´|ª ,Ò7"†È¦»¢X¼«(’Um9ýfÊ਀ÿPo(™ÀE6á¹Ï‚AEîûƒ÷™äXyyq:É~“MžØQ‚/_q R¡ðÞ¿f„ÚU èËï¾Â¸§‡]…r,e×’N+#ú‰Ð"¾j÷n£æycÞ€Šjû}–]ÂK¥ÛuN•CíɆ¤o#5œþ×ägáì ’ëÛ­2›âm4ÍÖd¤~i:üº%iè½q™‘í yGöøÐ®šì…=d …$¾!AfY-ëϨ 3ï6oÒœ9ÿÎFQ·8r³ˆ·135ïå,ç¸ìœŒ ‚¾#ìFÕöï4õ`¸JFf'çÈûº5m9¶I.më×òÈEùUW7g•% ñc™-¸,ˆ”ˆ¸*Ý(¬%2â3 ¤nN—$ìü3»ŸŸ-VAv©Šºa3~³IÄ7%õ¡;¿%v¤nô×xQÇôûMr,€B¸Œ_ófšqzá¤'à§·µ9Ë_yÜÇ«j4¾j-ºý‘yAëð’á–%„¦ýüuá’QäïW^NëÅË`Ö>£ÅǼþ+’ qøa¾‚ë[-éXº¸ðfÀÔ¾Û[ÕT³;Ë0xfâÚ콓B)L²)4"(¯SOÿ+…ÝpzØi“ÃÍôxø_Í~/†»¶°`§Ž n!”KCЍC}œR×±Ö@-6ÁxáݯÀ>Áz¬í—WJ›DF°æ ˆ¡¬QQ2ŸA³Ç¼c<;¸m"§F|¢¸‘ùcV á©‘$̧ÔoÊ­{·¡&•*#F¢RaêO¤`ˆ¯Ë‡Ébq6ÏÐSo™;ĕڙûe*{W`Ȇbúp""ðZlGŸ Ìž ®·ùNkïæãß|š¾Â¦™"ú\ÏÂä[”³Ì¨3!ª®h9­Å-mˆE­öªE–=—ÀK›K{)–ïhDÃêÄÔÛ[Æù$0¬­épõáŒrª|´?¶Ê&¼ vXV8#.ÝÄ^ nàôk æn‘ÅG‹¶ïœÚQeG)ÚVíp‚*ðmG ßÊ ¾h°õ(1!¯ŽãÞù¿‚B*+køû•óÖ†} oí¯ÎÝ ÉRªý’åDpîm|ûJ¾ÉÛ1ÜÌr•÷·ZÆ-qüã<Ï—öÃŽ#^wu¹MT×-YÕà»öl9ôɈj0…^ èÌk_¤¹[ZaKåm–­5¥—`íÂ×Ĺ´Oà<Ñ Nbá8dÔ¬¤®1ˆ0 ÍM{O¡ôkäóÄp\¼TòÅÜé(1¯ai€‚î§G´4$>HšpQñD?µÍèlB’vbp¸ŽNNs,‚ Én+øjKæNª‚eK«ÍãpÛ˜LŠ;ŸL„ÊÁfx°H¿|xXÛ™‚Ùe;ÎK³L_Hh/ŽZhÇýÎäyVÄ 2÷ Yò’…®ýÍ.Ÿ[Þ¢$Ø–W‰ý„DœD×hzòÙý³Exí–JNƒKÿöŸ¤³p2û·˜­~Y{¿}ö®ëÐ]vbª4U ,ÑEˆeø¢ ˆùWÉæZ۴啘ê…TÎó©ŒvÁΞm£¡§D¾Ù_€žáNѪ·D±ÕæiS&ª‚22Ó%º¬˜ß:ýâk³¶‹ ¦Ÿÿ|“ËÜWúqÜNœ’5çIT½ÕËï‚y\«‹ZkÁèÊȧ|ߤ8b D›ÅJÐIÎ0q+3ŠãìbA—þ&…EžÒçµ3š‰áG÷CQ-´ð=²“Òâ†^tYöÆnû¸m²V<k²ÆµÔF7izÀ†O]š¦ô-y?p\ˆz#3LKšwùæÓwhšsj}âYO}<ªHŠóV±t¤;L˜fZ¥Ý«ÎxCÓ lp‰Qö®©K“¸¢ †dâ|БÚFû†Š9QêkF-eÖH¥Fd4$™ûã•äš! 76ì§*âÓjæ&⋟Úí6$µ@íoËŞ="å"XKÀ™bËôuð K¤ÚèáÀV÷]°Võo(]k0:Ñ Õ¸èg‹rçoý£uo…)»0!20½IîñIÊ…m•{G«8JXa<È©r¦1§Ç’#dÞ©aÒ¡üF|°ã_Ъ´Óù)éǦGϵôõÖƒÙû|ºf²{)!Õ˜’¨ÿ r0n8Á=v'÷Z§E©·‰&D´Ç]ÌEõŠ!¬¤6ªK­pÇy†ng¡ÉýU jÙçÂâ"#E·îLOé\R¥”çÞã´è?ì˜$ƒ{,~å-j|!Í(†˜›¥Y-Ô#Gn{.­Uö`K+®õK*ÛýÜg¯QOïqßúïû (kºˆéW$šá|¤Ü‰êÜÿ’_¶BÀ;b”·g$ Œ@D–ïZ^/~0ˆÄ}«Ú^Nz2ÎgýÐEŠpÄyîõÕòÒ)¿Ö¾RXmVð¡RYà]¸zÇÓpÅv¸¤QV®¢*{hAžw®¥ è¥Ý+´Œ8Œ¼EUç!Ø£»)ﺶµÚ³_“¡˜C¯}+碿Öë6‰)Øç†ð àºY˾~<¨`êÙ.ŸwuóžQŸû•5«¦qëö¦½5JÓãùt( ¾a})û`ÎØ²Êެt[VQ¯ Cnï~Oœ¿@"¦â“ß!ñ^?TT ×@)ij<ê‡Ç©.]ü¡O(D<¡:\¥Nàæ¯ÜöM9_‰×÷.Œo†‚ez¢Õ ¿z“ÇÓÝKÐq'ÃBý×Ýï‡iÙ Z+Ä…2A”’üGvù:¤ZEH ÅllÆ–5?®íùYé|ïô‹šwioR‡˜_|áêÖZÄC‡ŸÞJYuÂæËa^¶×I¡eè 2oKÐjF¨ ‡Å ÔíŽýl´*¸ Þ0àX.íEÐx{—Ò¼6–S‚aNƒ [1¶ë¿î©0¥"ù³Ù­x•‰°K·a=Ïö;ºªŽ½¬/'Dâ«•à–‚k*54#pÚJYu†¯A™"wdÅ ëˆéõZÓæøKZý…xÊá@ýa€„dSV¯ë¢J«0–û Ç]+L樸ÐÇ[ÌÑ]¥<ÿ̰M.u/iШ- tJóÒ'Uùµy{ „Õ ™O…½Ûø¶³ɸ°lü³N=æVá‹’ b[OZ‹oÏ9ÏAŒˆãÍÏ)ØL„Í=æ?åzʳØX¨ÆKáLÅÒ§IKÑßìòYÎ%c­_5k±È¥xã}²–qwâXé(ù ܧ”Lwу].é¥$Â| Õ†~kAaN]~{«€îÃ³Ž±“~ ò€wIÏ'Ã}ÜĬ%î¥ÉpÒC_–®rržÐëÚr÷a™œMY +ë•g”ZþFì–Õ§ºì}“·{£LF¼0ûb‡ªÖ÷¬zdXü"5QÕ …‡®þfƒÌgƒOp<\æF ‘ÿP’Ö2 6HGR2xïÓ¢™ÑÒ S”-”²QŒJù‰‚Ÿžô.;7³€ÜÖ»ÆóiÏXYV_8ÓŽðÝ^öÓ`rF#}ýhrRJLI)EU¸…œÚZ‰óçlYæÃ̮֜"†‰:ˆŒ¯[ÃK.†åýã vbƒ`Á*’IøÑ/a±‡2܆cwè‘f*JoH=,„\.I©?&”1ݷ߉Áì&`MTc8ßÇJeÍl+S}úGXʵ”LycÐd÷â½µ}]˜&Q”`ým&Í!¬£ºCÖÄizBLyèà!4®ÉULFH¶÷cˆŽ÷çå¬ùXá3ò:‡rlÏ™f6fN‚žëi, ”w-¦mÇÍHÔDAvÎëˆ \ µÓ;¸æoÒ*z´›ÅŲ$Ú è“ T”º³—¬@í<ƒYr ^‚Øèo{óªqÐ*¯©5Äןõ)”£¡¢}3N]Ý"hÏ´î¦:ÓvX %/úWèyøÑïÉø¬ð!ÕZ`FË0©,“c„W˜£&:#çÝ¥òŒ©* æn«{£®=ȾPpKC—™¡·‡£š£1=%<†Ñm¾„4œ¸öWøßýä»ê˨£IpŠã».CË~{Ô©„€ôüüö¶™ï§Þr‡)_ERâs×øö}<Ê vü¨ÔÀ¡ðÒ¤I½’ûl•áz¬½o#ßéƒôÄYÚº7;GÆ…‰+˜M@<^ÉmæÙ‚í#:"¥(»ds$B/ôÊjÉÎÏÊÐ*þò'Æèah†_ÏÄÙ»Tîã£ƒðŠžªØìí¼é%èj—çDã^³6 À»|èóIŸNU=Ʊ&M·sÝíVëòù[ÛÈ—'F­nh´ÇˆÜ;ÖÎX\+‡§!E+ gÂT?ÅÎí×5¢x]AÃèq]¶Œ H(”u‘5NSOxfÙ(wZà–Ä(ý¸|âØsÕf3b óm-¨R´ ýó0¯úˆRLR«\â°VßOrQø#ŽÎ4 a¡§$¬GéóˆHŠxPÏrN´_WzõÒ´ïƒ2#‹-Ίù§{«V¡hèsRl7â0ÒA:  ÐÍ£V [¤r©_žì)ó˜4Íõ°s˜„»¬cm#oJÊ·t!R<Òþ}kíHax>ò_\0¹ jŸM+J"7]Z S®D>xµI À&_ ”êrZ·ŒïÇÌõŽ#À­7ãäýƒ=mI«š-•±L"ó-ƒn›#MöÚÚ¤ÌÍL‡SëØsVe¬›ÀxDâh³5îºý…yó…)ƒºgZÇ1b Õ’ôrN‚RÁ¤!Þ=ÂÁüög˜«VòŽõëuDy=µ+s•W=J§tÑpóF-K¾Ð¥„Û«OÞ¬¶Ú™ù k;—Â+R}\ä•7›ÃC‚Xrán‰&Ç<¿¼¨tسfÝ ²Õ;Y¨{È:z†ö<Ì<ãäÓï`Ô‹Ò­€Ä˾[6‘)!<¬Z (ez?Ólÿ~Â@%3nXM«ŽÛ™ÛOZφ¼Ø0Ý6G-vVlñ WX#;d×âÚ(îÈôñ˜F¼Õ.jgY¾Öޝ>æsŽts…ªŽ‘ºëår·îÙÑ¢–$ÆVÉcB>µ¬¹µRšÛ–ÍH”ê˜ttp*t.9ŒÁ?¬ ã¾ }CVv–t FªðË3è™?1ôùôT eÜæPÈ)Ç·SæOóF=ÅßKÊ…Å„@Œ"½©kÞ võä-N)–Ô7·ë.|üýV§‚*e½³A`“ß<ƧHnªüNƒ!…©ŽåOžà&å5áä>¯íHÊÎ5ßÒ˜(s 1Û—&†hÓeå{!G 5<šD†õäDЈ˜9Ý>\q¢•b „] Eø<;tâ>ž’?5ÈÌB­³<îê_ñ¹‘ž\†/Š"¿“¯+C#Ðt‰¢¬ÄÉß6î9Df;ÓÉ×è i ZÝ3j+›0 ¯À°W¬1&ÂÚcìþ|&ùÙïÚYh¬ÏÎÜܯSÎ1Kgÿá–âÞ/A‚]¤=H¦Kœ5ع¥±.Õ ë<­m¨¸‘aæšÇþÓuGaCñô.ÐÈ—“èÙQô»Ù3¤¨T _˜çâãaÚªÑvwmÒxŸw@×ÅÎ;Pºëk­Äb[L#Fxà÷àÉ{ÁÚX‰¹‚W[úJ@É`zìˆü—e6~R™=×Ç1©õÙã2¨UŠ®¡ÎÃä@=}©u)ÿ0ë¼á]3²f²ìBn›ÁØ-Êœ¥NPCeOzU øñFÖXhÈu²olj){ˆÁRà\»Ýý«åÑàÛôE ãŒ:2ÕlKÄoß2pvü2v¹a¶Le¢V©´Äuïó‹€eX6zº2/uìí È‘Éc­1®’(%˳Ây1®‚FØÕ,”!0‡ŠGv ûôÖharhß’ó8ƒÛ/ÖJ¤#žf؉¼êok!:úúÒÝðì–H¿+¥w1b= êÅ!`Ôß)‘©¨´XèµAÈŸ0ÀòŽÓzP¹‹oÀðR°K=——˜Ä©„o¿ÀWל-Ô/©pKT_é –î½ChÓföŒý¹¢ç#§>ˆ»üX ûÙ.·RJhèöŠûA…™½œ[1Ëóù)žˆn½~‹ý†éA7å§Ä30²QÜ8("°ãÛ3À+~ÈÏEšÎúbHïwÂ[ké8¸¶Óq! o<ás ù&¾_>ú³>ƒ$¢ÛÁ’zð8$Hâ›Àð…ø¨Êt»ä¥ºªýOˆíLyk%Â¥ |ó“=à¹ØÈ=€ñ”ö QÿvoÕÇhx6Y{0wìGU]L kIZ…ç!ù•“xºÊäß%!Tš”xãIUý+“ µ³HµW˜¸—Z\6Û¤@ZiH[•~ Ë*úòvï²r’æGZõV÷è‘“?ù&¦6Ík¾Ø$w´Ëž4¬u~Ë¿ ˆÒ‡Qa“‚•5—ò¹ôiŠÙ³ t¥ýÊ‰Ï ¡o¸<CyžGÝš\”9žÁrÜT$„+¨ „«‚þfF¡ÈTb*´b¸‘§ÃMo{¬Á¿­ŠÛt…5ëºøœ®uëÚ,€Q7´ J'‚‡+r1¨@ûK…§\PAŸ'ÁuÑÏ퇢Å' Võ¦zðN¦lrOã´==n>¿:U¥úk<ÌžúÇfŽÇ”A8fÒÏiuˆAçÁºÚSë ßÍlÊÒ¦‡³V[š«: Es Ho‘þ=FIB†ªy^9ÿÑöƒuÚå6y-ÿA6‚;¡ÉîUò-JH •‚ˆòi§ˆùtö§ŸñŽc,À˜¥¸æ™Õ ŒÈh“b)c¬…Žªf[†/1‹›Ñtx*Y+‰øÆÛC-Ÿøa}·ã=\±|ðú9t5uô$$ äv:!lßìhàW&dÊcs“ËÁCÚ³ìB4¿{󌲤TŠt]4ŇRbƒß¡~ïyö2cÏSªžø@ý“¥Cw$òÄ/Z¿'Ù‰ëë[¬þ„¢ÁX=Ì÷ç_;¤º§9âr[‡í¾w²’àR~|ÎúŽ}yè(s3–£9î%%ºoSÁAU¡PÎÈ{ŠCüÜ—»ôðsß ¢Æ%¨L!¸¦£­—;/üH,húòz“rŽÌLÐùϾ^ ÌÌl+Fî©_¶ß=z´°\ ßï¤ï3`z¾2ùÞ8¡ €®­´*²ŠÉ°>š°LŒ#òŠ7Æ ŒÉc^f©àmžsU¢Ä®ÇeÛⲘTËðDÔÂ#œ…ORû™m2ùݱÀs%9]â’‰BWˆ…´;P!žà&ý½]颥‰Éâí¹*¨åŒ¬‡­Éë ›h1àL:È5>Õ¢ÄU²#¨;—~(£Z ±eÀ¥„1¡ž ‹¦¸å‡ÐŸ(¬|€c = R«ŽËP"~LwçÙB¢¶ ×aoA@­°ªÑRBØUÇèB„™%-ªË«×ôµ”©ü"Ý\Ö빦¼Ø™ÐºL›Fxo^µ2<ÕÒ-ûá2ªÕÌúºj»Àô®€à£üËÌQÿ(Ö¸v&§j\`¶#Ÿõ;‡JMQÑ#tÅ VMÎÝS´Ž“Cgñ±¯á´'Ú¶çr+ß™Y½™ºI…¨4ž;Éw ù³3Ç"ÛF+šxýö]ƒª°µÔ:]üÏé©àÒõóŸKª"¬Â†V²ŠYÏ04ß4syZ3d•>±åÒü¥·ý*¡Cî޵ëÀò¨L]ip¤Õ(c"Ìfx@°?/1J^‹:.¡æïuå„ì‘I%.-8òù8Þ9¿úL‡ôYKy„‚ èïäûþb’}¤)·L?^ÍÛ¡¬½k º›‹ü*ì"ü ‚a.¤$Ïc!™ä5¨ñÛ‚Çß³í„Hê=퇧* ò·B_« »š p\^¨æ&7g!ªTGš·Îš S®Š3iß²‡]±(ÑZ$)ß}5k8ÿ›òúEÀÅåǼgh®ý!AÚ„Üœ`½‚c.žadÛ"¹lšíZc»‘W[¡ÓÚ3^ÉÄXé »…c>ö£ÓAÁ 3k‰”—!}Ùø,šâúL—n³Ø$_×ÓZ¸¤WÄÎÛÈ%lnêïÝA ïÀOSÝÙ—è+téMˇ)ä žH>H )áñåáÀ:]þËî ‡¤Þ¡õHH¡l!š®1+¢#ý"±¦g¾Ñä€-ø‘²Lº†?*þZ .¢8ߢïK÷¤H¯rh@×®8º¼Ó™´æÂè !¿¯‚øDŠ­¹Yzò­%Áßz›%9sb@Põ5Ä„sQPfê¦Têoèßk4q"÷ÂP€‰ÆºŸ@ða»5ˆMvý±¹¶iý6aÞÝf È"áCAùÝÌíÑ¥Üd$„ˆ”ù雜?úñY$nKQ¿¦lÆfŸ_²IIŒÉZm;ŽéL™$cJ˰Ž.AF9Ëœ)¯óÞ—.t­m ¼Aà(µípï{pf;N#$Ÿôo’žRL‹Ã—"ðÂòûú‹ý®-È.Ép$ai@ߪËûÚû»+÷îùŒ¤d¬T\µiÕJk”³8JËÚßÔ¦ø4Ð<çÈïÅŽ]J§4÷;Ù8Pωgì­ð6ï@ìH„Kös-¹É@âÖþ™ VË3s´ •ÛÕ'7&5I'? Á^8#­Û‹Œ¾ŸËJoœÔŸë`·æÆm‚€ø¶x8)J/eÙ|Œ±½”ó’¸ÜÓU©/õléAVßD“@È41•ž·œ¼¨úM[lƸgAÉÝ/ÎÝ ,9ôCº:çßšY£¦ÉP»ä áìâÞ2⤵»šu›û*U b < âW[»¦ëyå€b,ù‚}:§SPÉè¶ï‡JâÙdz÷Ñ@0lœî]ɶãäÚýÒ‡‹´çnÉyÏ5D‡,tÍÕÛx½Ÿi5ÓZ®3¤­7ö¸-é[¨V4«ëíiU%ž…S×­ûÄûCs ‡Ø»H¿NB‰˜§PS%÷wÖÍœ£Ætj¦o#\m /Æ®ã6\09\î0 Ð_u×Í ês¥˜´©I´fÚ“¼2'?Vö Ïßf…1!áì´T¿òŸÿÏ2žJâ†T_8rü¦JŒ3 n~„¶ÄOËÕÃöžÏ•Þy³©ožµ2:ÁŸ žqïÅ Á#î¿§üpÃÃíR70—Ÿ'^Ý ä¥åÙ8ú¬>Z,·ø`±”3u+3åX{5eLYvÚÏ\fìúåtŠO‹ ʈL2àz!" *Î}¨”€#Uɰâ] œožÔì‘>$·jÒîµ,ßsìW7« 5¤Þƒn'+“®\gØ>f‘²×ÄšÑ)CÑ”5¶©¼ •«–зDjþ*¥Ëx6¼¡çm¸°ì÷šDÓƒ„—_žÃ3E´h¹rvãÀ´iÓ dîL†ßÀïät𪤞œyº+‰oè›wPöR¥oGŠ”0…"¡ ›òØâξt¡Ä¼gí;œ§‰[}Òßs^å°Þ-‚#9/À[ä&š÷ËÆˆ:óŸÆ&âT6¬Ž4Ô 36LÌi³šžÌªé>+^+Œµ^ãê ·¨® dôï®&:ÉÕ…4j®rDµ޲?#`QjWΰ;‰úë ÊÔjœ(Brh;b3°ýÑÎHÔð;ôU…ÿ\ˆ¾*߸¡ÝŒ‚zG¤¨®Ä¬üfj‘p¼ûÀ+¼ÂæQ„bµíŸŸ¬ÛN o,e@cëïÜ_Â@kº †Šó[ÈSèèA)˺Íÿq·±8 …¸ZoxJÎø+ézèè¦&µIücKû‹q¬°–ºˆQéÜÐÊ…ssD¦»Bi÷PæÇ¶…K˜¸ày K:‹óõa¤ëšÿG«‰°B>;ƒ§óv3¥ßv§6}dÈD‰€!ˆÓ¡äÕÌUê%ð³ÑûC;ÈòíåÐ'_íÞMeŘ3[F+Üȯõ‹îY…+¾ú—IìÅXsû!ÕÔgAÆÐ؛ԇ/¦¿íúT+Ò7ÿ·´/ !nœâ0X|ìÏÏ!ùJTOÙqƒWæ‰/‰æs¨ü8[q WÏÚXÔp=ª«F¦fh³©<~›ˆ–£ô™/”̓J0­Ù´‰Y‘^Äd_¹äJ9Ø )ùwÔ|ðXtS»~¢ÄÑìWÕ|ôÈð¥o7_èÄ}tz‡ÚFî\Ⱥ”EüÎÒ¤~d(ÌEÈ8ˆñ&¡ð¶L0*3œ‘H$VG/zåRÖfíb~dGV7Z£Ê3Î"Â'þÄL]<&/›[¢.ŸZ6£qh {ísíÀÖ~÷á±KÔ¢¤ñÉñ¾.èÙ,i‘vÒëþW6Õaý³Æ-Xv• Ÿ ­\¦Ýl¸HÏš‰TXL.ã?àÀºÀ½ÓÍó@ßÚc+Ô|»Ô³z6å <Úç÷¼AÆA3Œe˜i쥪aø¢ðËë|4KÊ/p—£ÖÎï{R(©U-ýeBP×P‰å­† 4Œ2×}õ„t¥qu†Ût_dY—WZ"Á»yù µ·’Qu¥z‹ ¹Ø‚é ëÞâ+dÄû6¡Aj:RØ ‹£ : «QŸ° {˸+^Uû¸ r(ääOµ$f!"8ÊéC)„ð'(ùœö¢4h¹kÕrXp­Ì´KéÉ b°‹Ïøþô‰ö6¥üÀíSŽgè ÎDÚ4ðdIÇ:ˆ˜Lš&îÈäˆ>œNQϳŸÞâCG²%@hôÔ(Ž|í%aJv“E}¼èºÂGÄ™ˆxÌ'±Vi»î×d„Õ¾ì†ÀÅ“Òæ†@X(îhëóMÌY_ šžOÄýobÝãT›f’¯bF!qm5ð¼³yfëÜ»vþ„@Jí@:ñ`Î!Öš¯…Ni>±u Íîu5¼L”Šð1ö…ZM[u2ºÊý3õ¶zÝkO .‘g}‹êþ—/CúåéS·e)tWØÍCºq¥}Þ b»¶vIö…$WzÛ[³þ^Ðñß(ž ¬ÝžhQ²’ئßz‘1ÅÑ¥h—heòýGP¤÷ðYú_­×Ë_ªzòAÀ#9¬c¦Õm´ )’„¶®âH$å©LàÖïééË·8ÔÔÖ7›£Öý5ÚØÎ+Ú5õ=J.Ú—^èåZúÈÅpI4,ü3i*©Ôv“1dñ÷Öù€Éñî× O ¿uü´­D^ÓgMÍÔ7ªŠ{žú×MïüšŽùIÒÞh(.Ó"ThêD>-b ó-žÉðó@PÔçWgŽ„cëu3Á99vÒ!Û½:!R×bhSÅÒà,¯¾¨{YBllkÍM":Ù8¾o žŠ!²¦K ¥«ÅdÁ@b JnÒ““:uÞ«×å{¥ø_«=P÷MN1MéV4‹ÌõG•ÐÒV¿\""Â:×Ti5´Tç];“Ç?Üž–Ú¾ÆËé+ËÀëY«mç‚©ÿþN©Ê–3 a6©GË ¸­Mê*˜)PÅßY¥ÅÛ.f$ëï¡‚í³bíø½ /ÃÉü/ôãÕtè”YKã~â͉ôµ .þH|© jHÎAᄎ‰ÀÔ¢ÊÒËÆ@NÚ,‹NfAì3Ä:Y·.$çÏ  vjªúÖÜ›s†\^|1Ë ŸÝ`IŸŒlÍ]ŒÍâ4ÞK1‚Ké:PjÈžß­ÙkziÚ“ÏÑñü09"T UP_ÍÄj¼„èw‰‚&bœ WÍ-Xß0ò–P÷¬:'¹ÃãjÒˆêIaÆîEŒ–?ßÉG8‰h<îF½¿¨Lˆ¶ƒ¸Ï­äÇçy»;›ËRkS‰ê Ü·»¼á"a݃{x˜µ;ñ²>G©)e—« ,Õ¯@hÛöºÅGà.†x²è÷šæm–¦3ƒtÁÃóׯøkl?ƹ¥̯¨X©…?97<ÒszÅΩ_mR'ÚŒÙ!=^Æì'Ò$ú‚5 fyfz´EÏöÕO0ˆZU¢¢H% K¤C†å #†qÁ¿Ö¼¼‰ØÄ2ñ·C2P°ðï´|‹áŒ}Ó¤ì“#û÷=‘S˜V—=µS « šu³‰Ò7Y®+¹>¦åþø)/T£m0"s^äXyDþHÓGÙ¡ÊbÊ…Øã ÅuaåIkÏín‚ZÃ4þü¡Ô;¿ÃA3]ZÂÊ5~>!:UçwÐÍtûª 2ò-<¾ñî$Q)Ò6,ÏD½UÊ”×EJWWÿ’¥ÙÊËÐwÒb‘}ªÀi\Zt1¿ùqH3]äÞ˜øÜÁñY‰^#œLATçO 8è~ôbeX²G"1ÊP˜¤D–42ÈzIÚ—±„™Æ~@–dðDæòôYWʤÄMêêËç~ Ä?Xý•Û÷‘iè— Véßë÷š¹÷Ñ9ÆxuΕ©»+èTÒ~TÁ¬Œ|Ó3û«u»°œÓC`—Ÿ®à¹-xï<­qò:­CüR°`Q¸ÒyE5«{øy$Œí©ù êÕðqÎæ;ƒ÷ÚsÃ}ò™4Å74ä†)ýõ6ãpìæðHrÒ¿ùYKîa¨ÎŒa,JáµÜèÓp-¨ý¼Ö¸Úòž? ÂÁÛÈ'ð8hA8¤s…¤P GQBÕlfáEòë_÷e™¾5muöZjÈœA¼Ÿ“)sÀé´y²ôï××CÇ#°sϵô¸äòd’a)êJÿù)ûØiKK`G2êü>žÃë(Æ6.ƒ5øç(ˆÅ§¢ ,âüDt<1Cð4®êàÃ"é—VîLñ•$ ÙÒŽ?ãÄ‚1òþïWá?àÓ$›mI&L,˜ êjš²õ_[Eñû%î„=§.EãÂWͶø™Z0g¶ßƒ®{Žó:‘žíí2øÈº¤`=çä!çäñWµRx÷½çÁLh*[׋Þ,àaJª6¢F˜?~í¸nœ±5# \S—¢3¯,1»S Ç:Wœ±zÛYÃÿ”AŒÂ_©ÖbޱîÕ¬ùaY^…›m àÔµ~ö‘|ú¨®lPt oß!]=>¨CæSD‹B0áR’d!}WlRøÌÒñߥ§«WA‰å˜­Pº!9!FÉÜÿöw §9Õ¾Øu¦€ŠTï½GoÈÆ‚Fô‘ËÙök¯8žŸ™> ÚVŠÃÑ +YËT C¯ €m\Ç.ˆb=º%$JÎv+'Ѝ~ó›tt£E›²Fc·˜LXž»óY'Ã쥆ëãÊ>,1·ÊøPÿz}yz´©£xÇÝJHtôo yNqÑEÙ<“_8ðe_ÊW˜ã¥…Šÿa…o(‚{ij¶‚Û€Zo¨ù ‹Oÿ°ˆËW»ï€‰ßr³ß˜.¶§•Èî¼ÿ‰ýƒØ`JèD¦›0¤’…mÞ'œ ÄTº81æøéò}f"¹êŽê‹ʼn¢Ã0à¦à0:?®G@V¶TMÖ°[#ZËÖõâõ{àNË÷Û~ê:aD.ÇòŠÏòZÃs~ºò› òN ·à¤^M;Ë Qì–‰òÉïyÓØËe‰¹Æ™ÒRˆôå5#C¾p4ïãš™8_Qh¥ÈÕH.-W“/*4Lv’Ü2~‚óŸRbÁ…¨£ªÖ'ÃÁc§J¾ì5‹Ì ‹˜¬‰«…RPLôeÉÙ¸ŽE\»"ÅGšÇZ‡véE ³IÁŒ=+j‡N›ob) ®ÁŠ,ŽˆbNáÌ37˜\1YžŠߟýôäeTz5„ï+𡇑6~vàÔ1–ÿà?”ÐntGÝS[y¬òª2ÿQôÌsþˆeú6‘AÿN;=to7Næ&]-ÛÁ|?>pÞã²;$À«Ù²j,ó&ËÌw¸º…Ô†Iï óJ’ɶ:Éšt ÂÎ%J¥Ï)×ÓwÞðD]¥Ó)˜'¬ (ñ×>k­³¿;/WQû<Áìçj=H/q—.[tÝ}o\@¥^Û¤Rú)ƒÖyr}­(‡§oE‡ÄlŸþ«2ìªCØ¨ÐÆ•)RJ‰ŠŸgWŽ~Ñrœ¤§Î§ºÙk…¾ŒÎ¿pîG¨ƒ¾d:¡ä–&^)urÀ1~zc-;fîïõpfP¥iÄß Þ„ux…á‹b‘Ìüýs ‰ÇêQX¾«–ŒCõ2ù(%¬ë\Àîz©ÅË-q”„‡T9ßÏÃpÊ~§0ÿÑkG“ÕTÖÍÌg‰Ê™?…ïáËìL X¼»ë`õm"_ØñÂ6à°ª†D5Ÿ9ïj—Qòпé0ìͼN‰e)ä8 ñaY¿¿B™]Œ»Æ‚Á+»öÙvSúD.­K)Æ-À]Ý]®Üá°:ìê¢ê1“ßÁ½·ƒö œ]’f«§‰vª00Níº€¶“-Â{†Ôóá{R. '©ºê—”¥«àñA1_°(ñæ³2Ü»`Rþ¹QÔì6è'š›­лƒR“)´ˆ‚JœQÒA|„m×?FÊ "pMÃv|-´Î¿–!ùLʾÍÔVŸ×…^šîeË$™þ{¬)ªÚ¥]GÖ¥²Ëµö}W’þu_êAM°Lê¶¶ÅÌV“?ú{ûØŽŸ2éûD(6é£,IAd »tVüþâÿtŒÅã±ïÏÆøJÅ@á°NT‹aN„™.-ÿ°ÏŒ,fJ z’àÜìÄb ³/æ‰ÙB§qÏ1óMqL-v˜8pjþûH½Í«ÒsHeu|ƒ/·œ 2ö8 f®õuZ’̵¸uP–[ƒ­3ïƒÒÏwÒžÃ{–@Šû…°q}Êb8+‡(Ñx“tpN#"D’eù:Xì;ùR¤_Þ˜‡3¹•#´ÏÅ+ÒÆ±’· ÏLŽQ8Ô0Õš;Ñ 1 ¤ì(½"gEÇê”òyH"_©Úõg~[ÊÐ2¢©ÓåÑWÜ]´¡ÙÒïïˆ÷69,ûHÙ0 íoð%ªÔ(©ºSKªçoCå–[u‹ Õ ‘DYºoì9 ;9gs RNë~ 8_“ÿ~s  ‰°ÉP!vyi]ìp-{µÔ 1|ý^aõè¨/Ê!%ù^í–…¿÷3hRÎr]¼¨Lä¼àü§Ò1K_sÚ6©üöQ!Xqs6X|gþ|êX´^9Ùgóí¼n©Oàœ´‹Óá0?¬"œ2w ½˜Wül@Ê#…ÉÀO?ò<‘œö¹wdS!¤‡}ŽˆÍWY ÔÍØ^ÍzÀÏeáhqýÉÄÜå¤sñ(ߦ2@Uȶ†5z#sàÛ?s¨¤°Ø.Å×Kæ<󣲯5³TÔ mÓ·î¸1w~âV“â…UOle"¨æ|sÞ³dŸ TÚøŒºé•4†¹…æÛ‹Ã5O-ïË ­!øe=_øÄ­ÖWìIß®§gÖìîÔÍ@DCÅØ´P”£àùø€¦e&Þ 7ZN›…Šœ(¥Š×Ê#ÇžÙd5Ôäë]cñôæ~0ƯèToÁZXjæá\2ÙpÃý¤{?ýˆp!Jà ÷ó *¹‘6~!ãÞA€Q¡¦g–8„ˆ—º‡31þ$ ¥o¼~“ÛÍ6ª -;¿ý-!ІOÛ‡ J*¾Ø„÷xºö›îscK´¬âÀæ©2a[bé HŒÝ8‹j/8qŽÝð>“@ÔÂ'>áºò"2ê43ëBqù5<ÆöÄÆºì;âîtâ ý*ÛC ·‚ÏoÇO^ž$ºV˜·šx¨f*}Oÿ|õ¦fGeÖw¶M·Èà;zn'ÿ0û-f;_f€)t~$û«åºªD´ôÛöp¨Wçldø‘[W¹}¯.†1Ô]°#¬††Á—¡h¸Qè¦*ˆ‹òÑá$¿&È:@¬Èq(Κux·yáèc·òæÀ*š°ÉÈ‘wŽ=6¥Ê´‘´RÏ%ãQrÜÏùç;H…žËPqž`‹Y‹Þù8IsVíQ¶‘5t Âɳ<"»vm~WÀœÙöˆZ^^Ǯɵ4,RÔ.:刨Û@¾‚¾5ã~¿YdÚð÷©†%·VÞ‰÷[ï’©ª‡ [ý÷þ95›^†Ú(Ö·„»a(Áí—„ˆ3º¥KúHŽÈiz–§ª þ@ã0&öȻɿƒ½÷u¡1ï@¨‡ÿ˜Ì–<)O¬V¡µ $B²9r3ûJß7I;Å éð–Øãu…ÌHÂëQKå7¹jªŠ@•]ðpdp¯o¼D‘¾ÇºÐƒØÔÚ¯€çù² ñð¿CQ‡‚äWŒ¬ÝäÑ&.…QCq*âæá°ßÞOÔÀó °vó¬;îZÍ+^„D®¶/ú -Ùžƒ« ñ0ã[Ì´Ẋjñ{ïË,æÝ©œúˆ¿ iË-oò½PÁÕnñ •3B‰=Â8fˆÇ«"k¢¦×Yy=uþ°}a§)Z0‚~BTjÊWäV>Ðjw@Ø nñ?Â/æ¤o3ÆßÕ.¡ôÆ[åÒÃzªœó eC‹‚ •+Þ’W½Q:Íu}á Ü+ÿ-—³s=Ö£: >K¢Ñz\3‹ψÞÿeyKD*TF¦õöw³½—@2¨€Eÿd^‡Ê­hÚR¯tÒXåÞ6Z¦ÙVÓ`ÖQKÓjgÈ¥ÕË<•ul¡Âàv6ÆýÁ~)!©9Pæeš­]R#Î[³ê¹Wž bêÜ®¬}¼¼êÜû}ˆ›ÑIbJb=%»Yo_…e UÚÑIü(¥w+ºù]ýϳ 1Éz~ÅMµO§>‹~d“"g4„p½A*.GצOÊx†h@À‹¾¼8‘±©Š Í¥ÑsŒWQH y÷ûÏÃ><¶Ôrååjœ½è 0aNï¢ „Pu­Ò«Öùõ„ývËRf<°¶Ó~"tCîçŠ(LŸ°¨¸¾¨L…÷”²êXM0¿èa_¾xäŒSÉÚcAO«ó<%W_± "!ÓûÍEÀÒÆÌ››¶ÿ¿ ñôó©Ø*\'6ôbhä~1ƒ›5†~ûકGqO!™(r,roÜŠ«B!Q[õÖ,or¸ëš ¦×’›¤KjjwZV÷wŸ_e’¢X²¬,ÂÚ§ð"³J¤VPÒËÑûú «œ_R]Á?ÞÎÐ:b ÓnéÁ«4g÷ÁÄ ‚Òí­ó]N‰¤E#&4nÒ—JîÐÛWþ”êòÖ…çeÉ/HDó™Q]ò,áé§sHŒ >6à .®ˆ‘[ôÕC øÉŸFµpì0҆δãÀW’Q‹éèÊûhðS6~°GA?0L;ée´=…Ó/©çÙ¦³ß9gÑ ѓީ¹ÕRÒ-šIYNÑõ6rîeÔuQm5Šëñtsa”5©âb·ã‚[3Þƒ¿óÉî3ûì’(:è‹Í$G¡öÕU‚Ϻ(,¡ŽÈ5 Ú;å¢ë5õn- Ð•ðöe”’À´ô‰R¡eÃ&Ù þ'N*¸<'Rm•§!‹aÝ>÷'Œ&ðìwfëòÙ¸_Q—ö-Ö¶•X+Öfü­øÈtÖŸÂûŠÌïq´Ë¾ªÒËoA^o—îw¥ZgG§®”ûBM)[ÁIé0[>.ö¯•¦{h¶„"“%w# óÏ”ò·õìÕ@ðÀé.•q“³ò„»O÷y¶¤ÃÅõ䌟î¹@^†¾T$¸ÿ“#bDf*Áàõn{v 0”¦ýÏš‰Uõ”-+%‰UnÿÆð9ãýÊæ°ð ü}¾h3°Qœúšb?õ÷ŸFÁ†D*÷£<°Üv¿æþ•bxàÄ2Ø7×¾ŠÇûÚŸ¿]ˤ1¯{l…¢V6"< Yõ†+ TÔ–eûG³ì ÈRÉZü‰Á›"A¿ñP]ºáÁçYrØŽ°„ºÞÜXæÔèyf”3׫ý¦¥d“n¾¦uR cÖ?×ou€Ã‹!sŽ;0)bñ~pe³¥Rž¸^´Âó£X%(ßæËÏQzSÝ* š¼4ï‚ÿ8<ÃÎrˆ½7ü¿Ñ[À¥*¹#fS¤¨+ráßÒG’©µó@C˺ˆò§zÖcR1XläXÌ#˜]v zµa£¢žNª$¿ïÀ&ÚäýG\Ç1ž`öqK»K¢Ó!ÌåK©¼!_ ÁÇeš†î#Âd 8?HÇ- ˜JÖZ¼cÛ0¿Ò‹Ë"Ÿæœ&uyZAž³ÝبêÀŒ_%±^jýŸleÌ€îŠMÆdįAsÇ]ˆ˜Å”Òâe;#n¨ꆡ8ÝÀ»í(Ó'Ô~èÇ9檩G{OžŽÒ!ØÇè"ÍDóë€.w…¼R×ÚG–7òQx xdKSk{B+vÝÉ%“{'DYCî¿yŸr±Ø›¹¸žý䈪ÑPk渽ØQw,c°E|×!MîE)Çb¢Ò ÁÅÏ“ZYQa”Ü[\;¥5•D¯4üŒöÿE ˜èe‰¸…€ñ#axG4§Gfo‡ä_õkûÚpâ(¥C7ߥ¼€v­­Äs±Š†>PÎZGrÔ'mkÌ—ì}εÏižºÉŸb³—e$l„îRÑÅ­îWMû,HbŒÅ Ìð8ŒåDÝ`aLJfrÅgúÙÔoªÓu©6?V iö2Ô|ФÉ΀rÈ@Jã5QÊìÝnd¬uZ=q`ÒF£v‚ðÒ—»ïtû’ØJ—ÅûõÜ”ªŸOßðˆþH`ó4J7 :õÌJ ØD¹|÷7j´®ªÄtiVèͧnÓΔ8âlÛkض¾Äæ¹h`Ë^1ÝÇÕÌ1¿‹?:”Èл µ½R0¼‚ë··zÖú{À·«ØÎõè8 É ÞH9˜zX¾›“+3Ì1‡5eÍêuajs»¿¬mÍè[ÆBÂÉ! @‚D {6ù…!C]{:Ü#+AOɲÀ±Ÿy~NŸl?V-©¯¯C³ÞÜ–E+"ì”§§ȉ¡¤-xYïÆµÁH‰bLß \…§¸"’vé'—ÙììpAŒÌï9سà°F ̾{o¸ ³w/fr Ú½­?À96¶³#ó"¦yŽÅh)Ið°Ø×ÑËlê›ÅŽOûòƒÈ‰黀/ðÓzNI*ßôV˜ r³“72y¸ãúðE ˜ÔÕDVÀ"®Ôœ,óh—G‚ÒÇœÀVm|¸Lÿ¬S¢Ð»¢k9:˜VžYZwuDùØÄ6âý؆ý¹s$<[o|{ÏónWVêqq·¾z ’ ÆmAòk™“-ý³EŠª£ëËQnî4eÓÀFU4½ò"Î0eüOBåukj°éF0ÌÂÞN­é˜Ø›ã Ö >ŽÀÞÍ €+[|°*r¶Rù3Rµ•A“Ï ¿¨kV—Ä­×Vñœðrld@:Æ+Æ»âöG#?úíïǺιgôÌn8ƒ;ÙÀÈ$ÄP‫sfzÍÅíoáFÔn€M~¼"c¬ F\“nñìf€û5|ýQÑG/ÁÖÔØßCŸ½Ì}?ÙÍ ßC•æÒG°“wçdΪR5)Ë4+ÚIå°«l s·µH€ó•ooøk”Ên0çÍ0D«{Ö <<çcÙïÖßežº>d¯‘@±Ó^a¼¿â+E:‹liÕoeyi<¶áó+ŠžºpHÁÜßäF ¯E¶-7ôž è6ÜÀ×䕉%D!µÚ"wŒÍá¦f1ǼuÕ¹ÑjeH~…°æè™iÛAfóT‡‘ˆJ›¸žV–Êf-Õäç:¨¿…J2J™ÀéGÒƒ‘™€›à 'Ü/¬ˆòA‘ç7rœÃú’¦.‘¬;nôÜ©•ÐFÛI’5‘ÝL)„Ú+QX X˜—ýOÓ3­÷¨ÌŸ¾‡×ìEêXßœ4WP•?¬ìý‚ûEÏR†=yÀÞî¶»ªÖÂë¿ÉÕ˱ÙùÊë”:ðZmÕÊ\£e/ô’ Ê7¦ªArŽ6Xng(“,'yð¯Árõ\ŸçÍÓ6öæ«ÿcSõWëQÖ:}Z÷ˆ½é6ܵ_MOÃÁM=$@ÇÏ1ç )Nê´©û~yòËÏñ©Íp§"çjy²…]ðí‚‹«GÎRµRý,ÚOóõp^–á?í:ꪼÜèMtð&ægïiYÕê•t]”û¥2—}e³O/S‚iν›K¹)½BìLAt/åÎ> stream xÚ­·ctem·&ÛvíØ¶m›ï$;¶­Š“ŠmÛ©˜Tl'U±mv=ïÛ§Oó}ý§ûüØ{¬{^“÷5çkQ’ª¨3Šš;˜¥ì]Y™XøJ ;S75;%^F5 ¥›¬«‰-à/Ɖ@I)î 4q9ØK˜¸ùÚ@s€Ð ÀÆ`åååE ˆ;8z9ƒ,­\4šjÚ´ôô ÿ)ùG`êõÈ_K¥=€êïƒ;ÐÖÁÑhïú×Åÿµ¡:pµ,@¶@€¸²Š®¬’4€FZI ´:ÿ-BÅÍÔdP™í]€´ g€í¿3{sÐ?¥¹0ýõ%ê0¸8Í@Í€žf@Ç €#ÐÙäâò÷rX:›Ø»þ½WÈÞÌÖÍüŸþÊ-þ•£³Ã_ »¿Ø_g*.®.fÎ GWÀߨ*RÿÎÓÕÊÄõŸØ. ¿0ÀÁ⯦¹ƒ™Û?%ý ûëæ/êj²w¸=]ÿ‰e ˜ƒ\mM¼þÆþëÌÑô¯4Ü\@ö–ÿ™Àhiâln tqùëæ¯ïnç?ëüoÕ›8:ÚzýËÚá_Zÿ+« ÐÖ‚ •íoL3׿±-AöÌÿô‹¬½…€•åßrs7ÇÿÀÜÎÿº šz†öo&æö¶^s ³’ƒëßšÿ;–™þûHþo ø¿…àÿzÿßÈý¯ýoCüÿ:ÏÿÕµ”›­­’‰Ýßø÷žü]4&ö€¿» øgÙØš8þY8 ³ÿ©‰ÈÖëÿdü_µµÿÎúúü¯ð¿CˆÚ[þeˆ‘•“‰óßb‹Èh®r5³X˜Øþ½¼É5íÍζ {à_’ÿu¿XXþ ¦a2³±ÿ‡ ÎC@{óÿZÃ_ÞþU³®˜žŠº4ýÿaÛþKYåoW¸jx9ÿ3’¶¢ƒùÿ:üãJLÌÁàÃÈÊÅ `dãfù;ŒÇ‘—Ãïÿ'쿱þçYÑÄÕä Ðgabaaüýÿßž¾þ7’öfæÿô‘º«‰½ùßÖû_‚`37g翌ÿkü­ü?Îÿ Ðh†°ºä`Æjž•áZ›7OZfÿý²ª¯Pè—½¸à’ßp ·ß§KÖ¸wZŠ« G¶‘+sŒ÷$¸«©p@&ƒè¶´©ƒ‰·]¦”±u¬ÚIìtò‘ó¸œUD+‰l 2Ò-íq®ð]¨÷ÞÈÁd[ãñü\ÈÛz½šÕ”vhŠK:>-H îÊ0WÞ^œ„3ø°ö½>ÞÛA~f°‰dŸYš˜ ~Îâ↱Žô¨ ·8QÑÀ¯“ÍÛ&† ­²CØMâ6-aƒï›E3 Ì#ªã²t4)Á4Ê_’ 5)ñ¨ͰO§;çzãâë(×ùí,Sߦ¨Ñ“bõª¡ß)»0å]-‹Õ<³Wã¹Å®“,+±g”u>O‹1Ëm¢‰¼Ï®¡~>Co˜1tõ” æÄ“”ý³ýü¸MÜ Ù— Ù壸ZÔJiÄlÑn£ùH ÞÎ:‘4Ц+ûÛ6C5O˜4勉Ésîj¯4:ÆW©xZ ëÁ¦µŠ©.$°én´Ûä¶öaá&Å&ë{ŸXYRœ©ÝTž‚ç³Ëœkc{æÀª‹Ë€âˉ"$ÎØû~†*U¸\‚ñfR|ƒÊçÅw›ÂÓ”òÉmùq7ÿËÏ÷V‘7è¹wÜueþtÊ2QóÈô·šC¨(„cZgËLž¸[ÆÄ±ƒ— ýò_o@ ö¬é3J;†.X½Îk]ÚHT³*ûÝÇÈëÈWS>×Vºþ¶T…Œ¡c\|8ÂlþtåÆrú^ Þ ªb:¬Þå¿I&ÓK„©ž󓬟L^éªÎ2¢›<_•_Þ¾œ8“B­p,`MœË £§Þüáp˜V^mu•²ƒ‰Àۈ߈sB jKʶ‘ƒ~·íüä[§Ç£ÌœaXW¶PûV¡#À6M@J(¨­ø8Þ*÷™qÉU«Œáƒ¿CÂe˜;ÉíÝÏËöÜKÝ0Ú±`-‡0·÷"¿GB)ì*À9ýC¯š—Ç~«ØÞvqºÁJ£å¥CPWÛa*þÃÄÉXE3ËÆÏ„}KcBt'¢²ÊÂFfªÇ+©O•<}jÏPÖÓÈHuM´QÏ:âCðóœrj—""Δǩ4ÕЊ2©Jkáã©Å#†:îsȈٔ§ç67]%‡£8m3¬´~=GAHø5$Zµì!ÇcÄ*½t@'Ë3Êg 5 ê ݬL‹˜|삯¥[PM'†9Ëc‰:µÈqk,³ã›l4.…<à3l‰v[ÖÌOp¼m¶ÛUդØ?–tÑ”¾SÿsŠ•³êÖbFÛìÞ.i,æ± »ÂýhÃ/Ê„ü¶©`"üß Ð;Éž<þžv·5+’雹Ο¸ üiWòPùcï†ÜO3AÉît”Ä(‡¹³œBΔhÔ|–IN›¶$ø€/À‹oÊÓ‡T\ñø-NË2=¨ô íç SëË,¾ö­5è¢X ³‰‰øå—Ý9jÇDÅR “ÁêX!8vñas1 Ó²/±˜xug朓kCFtv‹D8¢™XÖî“GùæìÍN_Ý,÷0«j>ƒá8 zm›å©3cGb菱Òloq|ù‚FűX(}¡ÜËd¿R–2A•s(£5µÁ–É¡60"°©™<íB Žî!ƒ² ÏtZý'Ø¿Ò[®Ô™÷<±±‹¾U,$ÒHGw#zÚèÇcÙN¿Ÿ“ê)Š²Í‘Eõ׳ø‡ÁkbDc®Ã?oÈ™™Â²'EQD®›æ®*’’› „† µÕÄÅ^I­ßݾ‹.”-E ƒqÏSTrbcý½äS’çÍ$М.g¿3š„‡ržr~.>[É]v+ËýÐ-È 5¨ðñã@žä2”ñ ¦‡ÂhÖÉœl£3 ÖÔó)¿5-¬"F^âÎ6€z§/åV–¨ÅŸ_ß·íœZ¦ŸY•ÞŠùÒ÷1!uZLß!&Â-C ŸKÛɧtN¡>MŽÉH»¤GT¥)e¸wÖúƒÑ`B((m¿ÅLB^æ é{JWe-ÈJë²'üŠuhÿU1–z9NÖå ¹Àù†¥Wý@z9«Ž•æÂ Go[9À®¢Cɘ°§’P‘íz¤ÍŒÚ#sR:>“‚¦š·Éü=¯î;jÿ¼| I¾^7gí·ÀÍ¥0õ%I ySx¨ÃŒ~Âsù ýs?RÂ7’rgaГéŒ0jÚªl¯b.õVÅVÂ×T:±þ¤·jþí“-#,LàüDÑäÒÚ2ƒ—ų+ EØzÈQP¨½Õ`6†3 £õì4‚b¹Ôù5 „1àF¶T /} [rÍGuÎ&^/t>Ũ¸í ®Zrµ…@´ˆ ¹åÒøVíàž4»-º*7P 1µÛiZÕæm3Œ†õ¹M ÑSGÉd‘zk#ˆÇýûL÷ehLç>´üîÍVõ0·î…¸à,ßKC4Íh_34‰)ã(ƒöZI– ­< s4Î]!šj¤¹jŠ­«3ÓuOâw%‡†ù"ÿ~½4V×”öÊù«D&fh"á«8Æ\e˜£ í|§`ÐF* ÁDrÇö‹’†‚³‚)ÇÜJI¥ˆ lñ§ÐåbužÁ1·ƒšh¿Ò£X‘CÝ;9@ÿ3"^逫%ûW«ñ9ù× ×—zÇPl›h’Q<Œº¡ß#©ç  ~ïJd"Eø"ãÓVÚÎ…Å~æîÁÙ¯{½å˜Á»Iåú´Yòc1ŧ¶ýÕ\Vdè'³üìûsÑU†oŠð?GÊQÒù?…[mš±YÁŠ´gaØ´G2 5&ž?NÕpÉõ*>2¤¸'gÓlпJºe)-àDæ® ×@fñqfþ¬€Í÷Œödœæ–Wì5v×7M…~èÎÉ ¯·Ã½Ú›p!Aú€-¬ûTšÏðálEjø^ÓMò©©ß[ÖÖ^é.¬õùyФŸLÆ#‹S {¡u«Æ.7‰pgŒ òä ¹ø­ªŠï7/¶Ú´ŸK8]P}¨Ñ`;k‹œy‚åÅÒ69|pÕ\ìÂs|ý¢X 0¡]å,g|¡"xøŠ£‡·{Á¥¥âá¹éœ#I~~éI]ê³ÿ¦©W°nDñ&ú´Ùm.?»•3yÅmѲ˜A·y=¨s“ÿÝB°w GÏžRð|Xÿ…¬öÊÄ~^ œƒð¤ÆNMÝeÑçxBÀéû7ö‘÷.ÌALæiR{ghR”N*Ð(cæ„8¤ï:¶Ù/{ýg톦˧šÛG–[¦I*8JŒcÁ;×Ï/&úwç2a¼rP9õÔ—þð93åöXÝ )Ýpüs¨æŽZ¬9e zStÉ„ÀÅ¢>!.ñ{µ/m¥%àôO"ïÖÌá=Ÿ¥ŸK”ðAˆßÅIdïãÐ"«KäH©Ê`î Åý¸ À» ²a †ìože/Â*ý;d‰ƒI³cª0Á#z]2yã[›Vz 0BX«|Š/øý#³´š™XÃk…E5˵©BãúèSÓ{@Ï / çüN^×Ì—p4øjƒ‡/æÒÓæx½™XxJG“ÁP M«îÀ—cðCyÙÌ|h(ÿþ3T9摺($c[[p_è4äê6*?®5Ég_ ¥—céšJ «º!¸üš›B$7hf©÷6‹vÐÆjRz?(b‘¶Ky–½¸Båföç“r~ÖÌÕH \÷ïgÄ “uV®xk9ÿPÄ=ÆŒ“›4œ¹Õ°ËÛ|ÆfŽÝs$BÛ—€ƒüÖ[–N¢íNH ÿ[kOa»Ú krÑ SÖCjƒn$qa“ÉÚWéI’×Ή 6Ëù°æÁï¢qcµ\CÚª»Œ¹nA °§]üƒëk#ú›ŒÙ+ZyÖﲓÌÐûtb´(™²>GΑw"­p3K©lêZ©›P"<½ië1Ý;¸-£Ä!J‡K/ÚŸÌZÕ0>˜~a×n9E-šKÇ”¸GÔ¿ÀkÛ¤¦Iú;<ÿ¾>™¼^{@Ï÷©Žw aNF`^é­£ðH&&¤ÜÛS" yc¸ˆøõ8j•f:a´P†]®ÍÓ3QP¨/NU=·Éœí Ï> Ï!M<™û°šþúÏt<4{Âιz%Ý Æª’ oõ‰UŽ£±ÿ·Ÿœgi3ðáËå€á×¶Å¥³íRKå5ó5¥Lk~GÖ>ér;—Åâ¨N¿äï¹q~”¼Zõ/³ô¼k‡M*àõ%Ó%-Hø<¿Uê¹Z=à"â¹à÷:]3“ž¡5"p·E~‘üΜsxù€;”HÈTòpXg¯µìœÜEoö™¹ºúïŸWµú ç{¿Q©tÅ2‚?£ìÑcÇ>íqÀZHpÛ³3G;ëˆb&ÏKÙˆJì =ø“ì§sË8G´¨\Èl¤A+q3’‘s<ÚlÌ2ºjÜ)g=´¼Øi•7wÀ+jcΰËèÚÁî šOQ>äa@žn¾^Œñ#͹+Do]š»©u«l¨‹YÒeÜU[­¯.Í» \Hô¢2ÃMé©e#R• ³8*qmöÐFÍ×H‰]Zø{'/µÁÚâ¥ÑT„á“ç”g?È˜Ì Z\A§DÕ ôÊ\È«2×ôÖXëÀó2a2ü2= ÈÏð€Š3>?#Δ÷î¯s’˜ öºpH~¬g]KZB 5ˆB.F¢'V‚×ê\3ÞìwW ›ÜŠ·¥¼hD™]I½ˆ=ºÄËÉZó>õ’Õ c|¿‚"`H³üšªï?& 'é—•oQлçø˜ˆÿèO@fY'§k¾ H¹Æ>ÜpĪ[ò||73ÍGOe»‡ e-Æc¼{Nü,!~[~äß±WQìEÑ(oí7F‘CGN¥ïÇû![«ÚÕníœÉǶdp¦·y'G~mðSUSÕˈE‡6NK<î˜p„V@óêöýÌ3äªBv-ÅG”Õ<à9 ²Í„±…ßçöŸÌ¤äOyŠ2 Š´Á'‡ðŸöf¿P_ñEœc1£³†-GÊÓ<4MV $i»Hô#Šò·UŒH’¡å>%騭”& ˜ðv†)ºt§´´ù¬òŒü}WêE|¹ ˆƒ?ï^1}²}°yz6¹W×# î 7Ü9A{ ï(Gâ©裠ŹFóó³"ãÔ;'o”.i÷^·«éßN–[8Æíq¹ßI†7Z êÒR:£ÎSª#¯§øräj¤¸‘Üq($n+¹œ‡mƒšZœq¿’­6CíÉ!"¨X™a±×$|¬6Õ©$Ìß~YÉrJBò^+òu}t¨Œ[0´óÂÎC-[´°—“ºoÚ £[t›ú¶R…Ϧ±.˜¯$øýË}Q.¯ â$ypv_$J ¾Hqph*Èê-¹æÉ '­N‚soèm¹ù[*y·gm,–é¡~î¦P«ØÛ¢¦ˆM*é´óŒ‹ø+=˜²_¢IH‹£ÍOíªáŽÎò¬þö4<Ñ9hãÀ!TXåÑÓsÁXˆd[ñrõv©ÙÉ.Ü­2ûåký8 <—ζz+F¸&_hüÚ âee¥>…šé»xîÖºTDb'ªœiãÞ¤ž‹hÅþŠã,ñÝy›€íÛ°—¹Ía|†ó¦ÔeÁ³ÄÓ°ÅÆ:ý§ÇÇ{úI§–±«Ûì×3|<9il=çÌ8r¦;ES€³’ãôÒ¬zyÞ#8—äv§ëÖ…¬ãë»~"í§Ìªø1Meo'þã®|¹6½—ô—Þ˜esÊÞòÞÓ@oÜ?˜Ùq #º«ü‘ÞÔSãaëiÏ•_6 ª¤±Ì·![4µIÁ`„aüÔ‚ bx^íÛæïÅSs26ž„dô/b;¿ît¾jápT¹ "ŸõV%omGxúΛ¥CGQÐÚké'áa"¿)¨p…ЫrУ((#*R jÖİ_V:e£øÞ´o8(:R­£|ÛLºEüqß X~.Rб ¼ö-tô}Œ:ÝhˆQIŠz—BFD85Õ¾kaβ÷1˜--„oïÀ@Žm‘ñÊ—âŽh¹19›†ÂHóû>@éK¬K {ÆšÅf­…ÞW_"aIF,»PPn¦h…¶˜;æz"ª>]b15nw*ü˜ÜÍ|€SMÙ¼´Ì#Ñ 8ƒW´ûí­':o…oÞàND¡`ó’—[íŸ:§ÅbòÃÃ!KŠçÇ1ÿ62ô“»á× ­ÅP§~‘äüUa;šç±öuÀ Y‡¦aû¥ÆpLÒŠÒø}ÎHÃcf¼ãÂ?b¥NȰ½Ëçoûe‚$Ê ½“0 *ˆ½ëN BS-¾ïO4Ð} =do>ߦRM\V.¯7 BGÌzÿê"’ ötŸcÛ°“'ló‹ÑƽÌÏŠÆmŽšVïÛ#ØùĶuJ›ßù3xÓà¤\¿œÙ 8åU[‰¶p¿xT|«X¬×@m*+Ù‹¤{?F]”m!™†ídŽ+ 7¥ÄŒ~•/"ÊUà[Ê4ÂRÀñt_w ubÏ©  C]ßGP† 1Œa¦ŽøÖ$ êøý0ÿämÞŸÇ¡nÑå• ìV¹!§/²xØãMš¯7d1ª·dálìër2¢ ¦!ËÊbyLNT¥©¾Òzu ÉíÁ‹Wl…TµÁO2/sç¢Ü_sˆW`£B›_þB7Äì6˜Ž•ï"ºov©å–¹lyvÿñH¯¯'Á êHGa0º¸ÀxdÉͱ-eAX`å`ʤãìmö&ú ú $Wƒ¾ÖÒ:5Á|¹ìÃö$ßU-Ž ó‹ Ù¸ÐÖWϯÆþÍZ/ø_ƒ«XäÔ,FúPn0LéØÈŸŽ6ÈSƒìÖ|ѬqI_hùwL—fßq^º‡›°ã~ÐÙE¦ØÍ ÷%18×}³ÀæåiÚÝuLóJgß$C`'€°t®xCÉ~ÇÆ?Ö0ÚoˆE¼Ð8‚BÇ FÓ9•QRÌì/¿Ì5)Äí¡ʪˆæžNr¤ó°ñ<ÔÉnìÅ|Mº<ÒÕ…2_4ZL­Yãÿâô‘mò›I{CºÚÐTÚ´rõÈ déχqib~m,ô€€[KI¯„Û¯£šž ¸ ½Ûßt9—x£X+™ å"€‚ wc¹kè7±e‚C¹8ºÚëàiV$à éÓô)Ì<‘Èð7 Ægì˜ ÜmJú¾V¸DY©²{N—í!y‘WfH·%øËúËSAlh•ÿܺæÔü)åˆS å&â8¿ã®cÜOMغœÎ?ø^_zHÓ?àœðŠÐ[˜çÌTt9õ„jÐ> Z޾oyDÿ6`Åòo+*²Å8<—DímùØïgæ½a¨!ê†ö·vÝîpžXž…I ‡“L–{ÚbZ®8§BŠuýØ€±öþQ‹§LpÕ÷+Zw Tm~¶ç¸™l®ßn6ÙÝÅá‡î E¦tAÈ·9/8Œ!J,ÙíM_CÓнCk˜í×ûá«"íþä¶ y0mLÄ—ÆŒã/·4 ­’øb!Ó’#âÿ00³5d?ÙÉX¯®Ï¯÷,… ŽÇ8xVϳԽÍCZµA5.±µ)ý‘UÛÏô¿=íóP½ÇA!ù<ñßóé¢f FçâUÇ;k ’û“;Åd?û„ÉN¶Uµ)ͽ‹÷'Ióõøuq¼+u%B5ãyJ«ÒrnËÿì½FÙ_ë€RŸtžR+–ã;:ÒÂõyNœðþL7v³ni¢N&]®Žrï¼ÿļ J¶¾ÿªcZæ÷öó·£€ÆhS¶> ÿå0ºý²}ZOp²èøìì—ÁGd»Á‚VúÌ-´ „GЪÁ>חȘt êF” ý0ìȾ¤ †±¥”pÚˆ­, ‰<I´à=Ô>ˆÌB‹~ö+ìÕ÷Ä0Æðëå¹LŸ’iïö™Ý‡Jë 4( /Á;%1Õç[¨ *S”œs‚²ÿãÜ´5!T:…@í Y9·è¯ÕçÒÐÙíÇêÕdè(콫뽘†j¸Vrl2‰ Ã^£g.igŸ 87nö ¥=îš¹†+4¥ðßm Š“ v¥•¢‹Ë®…¸ ‘ÞTh¸XmÍtûoEÃ5Áq iqöìÈ%_Y覢3 òÛ븾KÈBëQ|ƒ§(¬Tr·}ëò®£j·”.·4"Ú9,X)Ð¨Š€ý~ŠZ ólÄ®0»Z…GÆ´Ä O­˜P<µá²“gÆp²À–Ž•mE*.tÂAŒš\.ÇÐÛš}DZ‡¿ä÷À&ûéh–¡H|M÷¾ÇQž·bÓ*°/·‘ì7¶Zi xuðIÇÞ¾Ë“ÄBà¡[:È`w‹÷Öp­Û+5'öKñßlÏ Ík,E e=”œÇ÷ÜÉ]{Ž_v 愜C¹+ÁÒpb^‚!Æ9̶™uÆöz+œ¿€F8’ž7A|¿1ÇËæfѸë[tliŠgKo &YQL±@‚¢Ë#Ëèy]Îv´^KµBˆr-(ñ_›åV%qƒŒ¸ðb§RfÕ\Ø4iž.ÜBdØéŒ d±ç’ÀrÀ\˜­R¦à\8š+5GÏ“sŸ Dó("@Žå#yUü–ª|¿/LI£¯ÁÌÊÒZZ³éÈ •c›W‰ù.bÜòÀH5nõ KA$eÞ…2¡åÐrO)M·¶§H¸÷ü»oùâ~ÀOÈ ûaS½žQÙí§X“ªvõ~„Û ììàâC[ ¡¹i¡“æV0£I T8-µh\Oçb»"´k_³+MY‡,û;.Ñ›µçNü€W­!ä6»ØØ›Û=ÙŒ$t”^‘[zÖ)×–•wY2£´(ÁDËŠìÚþÙé`Ð’MÿŸ)ήؽ(™¿/éÒŒÇU5ÌѼd¥ð~úå—‰";+Óˆ[¦´Éð±D‰!­Œ}Ûà„½¤P_û²SÆjå•9KDÓu/8Ñöñuk 1 s6#\³qÒyÝn)ï>í}yäî:¼Qè¿G=´ÍÕ/B¸AHwRÆŸXÇf) ÎN;ýÉ–vùnã& áx–ðIJÂÉ|„ÓðÚ}y )œqab.ö^àGæçåå9r6Ä}“5… P`ðÚ·ýŠÃ™J!;bÁ$Ô™?w®^Ñ8ç΄³«~FQËh¹íùãUÚ¦ÿûì3L™øïÓv/åZòë`䘉=b´ŽzCh03\³ªºæÍ³|“£˜xÐÆ#5raxˆõ1>=‰b¯Àù\Ç0<ÝúÅ09‚Ü´.õ/ êà\èM䈱R ð¨…Suähø Ó|_àW-÷h5ô€¹–M :mÈ+ìB´U<*Ï:£tÅõTBn‡ÖÝù˜h®p‹;€Ó—’– O²˜D+™ÉšGÆâϪ ¡ç[™zoá _¸K!Ÿµí§0®Ë79I5’¡¥Ù}ŸµÙAÓ5n銿OÌIWìèöTÝ-«ë[#ûåbÝaaàš '®)÷Yz­48Ík1 oõÔÀ–EÆŠP:¨>FØ+;ð}jÃé:k¢ô~ʱ'c`‚a/l‰ïo;ë :ƒM6°F{Ÿ„ X$Ïw6•9%ÂÞa!tLþj_zj ا–+RnÄV–T&A9¤$€¼˜4¸^˜Ý×nâH–Yf×Q^(*¸¹¤8+=àQÛ›)v¿³ãV¸"’oúaÑ’~€8`‚Q ³ ÞdBÅ6ûÁ=ÁÛ°m=fø§BؼXng7äètqf} 9$ ·ÅÍà ŒEo\}wziÜ@”‡:4f¡OÍ/š‚y—pÚ øaSX-zºHÃ'Ï)—ÿg~}ãC C\îa)ÙƒY"üÁ*Òc0œ&CE¥8|Ln0g«·á=û¦9£ðÂ` \‰u¤Ÿ=òèOG“!…ñ—+6(´;?ù¹"ÿŠ‘>Æç͋٩Ýé³Û>¤ ëh5¯ }*˜tH™kÙ ›:gùŠ+Ólú›¨8ŽjÙÉÆm…ÓUƒPqš Ûe™NÜ“¼/Üþmû‚Ø8šR'×ç“xÉd&æF¨H^Çýº]â Ñž€³‚tÛÃv^Òq½…cšÍƒˆd™@a&ˆÀQlnè>.ÃÅ-kSÆ‹. _0¹}83BJ{×Y%™¢åà-}/;0U±|Ѽˆ„sqçÇ+òCË«]Ây½o´çæfFÑ+1ÊãØAƒ¶Þ‹§®”ÑkB§v‡Û¦®N3‘Ðg=¾·V†pÈ1Œ=$¾Àáu(ŽôÒ¹YÅx˜á ~­u'‡o=Õ}Ü*˜^!ú˜<©rî„WBHH’7û³†Zj¦ýàè SÌNÝáël-(-žäËœ=±?Pªçá¦IDVH8ûÀt­è¯«ºµÃÍ/2R•°¢ÿ•ò´ì¢Û4—* Ѥ+õ7í*{‹a|tä°ºšç hVJq|>q‘ü÷‚xD—¬ñ]O¹Ü•gÂÌ¥a‘ŽzøY䮵çOÚ _ÑûÌ—Ä-‹Mû‘Òè>^v¯Ýw"Ø<ʃ&]ÈÂpüúW.û]±–û‡Cêv §`¦`§í¨<¯øÏ4¡ °?Œ}Zæl+å¥5­§ é;+€;<ï'°*ØØI /äÇÊÂB£Ld*ãr'úøÕì¼2Ý Ê@Š~‰cÖ[b[>¸§÷—œ>Ýø9i¬bûË-Í–7ü2ŽVjþL7š?J.““ÿÀ’ëIÆd¯íŸÌáÖG($÷Qûß,ÛÝÇQjj}V½z®çJ{Dˆ’ñÆ?~Âã#•Šù¦Q¾H”Dî… ëL]¿c€Ãi Eô‰õ£•ˆ/À>ãq<±«&˜0»Ë£ˆ3EÜÕ„t_‘Þ/—oôÓâÜ¢‰”°Â÷ž#ÍÇ~žôœû­’§])ãåÀU÷|5ào´^Ù¤‡~?,nëÜ4ü®QZÒ‡|Ý’·*ëßÄhA ððUÁe lÎùMÑx'Fèÿú9»q…3k¾Wfâ×ÔA‡®YxüMk9¯Ã ¦Îÿ¡h Ìë{r8ýÓje‰ˆK¶zn07ëx"Ù…Ly«%aó§|ÍõÍî–•YFWhO‡­ÆŸÎ!ðÏíÈ$˜œÐ³'´®¬:ù®N“r¹Qà¤mfP ¦×ðL?éédD0ìàSL燋J—.HýiGØ®ãÞàP¬âcC _ž@^,,\ªË+“/v¥°Ïþ«²Fpè´"í¢ÖˆyI9Ò^~4B0ÖGO»¹‘Ñd+ÎÑÚ§Y†¼CÛùí¶Jšò‹ø¼òÓ`ú›žÊÄ%Uí{]žÒu ižtL] ”|Ù·*Qš¤tk™Ç¾‹&§Ž¶˜tUY(b2ßz­Êz¡r—"îEá-óâ2ÁóôÜÉ¿ ¦_Réßäù;ôÄ7rwzá'È–ƒ¦Ç•ñä×ñþÜ,HîŸ>ˬLVG©VäÀ¬?˜s.Šrƒí´FGb·+ÒÖ$gLäÕÛÇ‘¬$Š0; s×qÄ:Á-$ÓQVƒ‚¨Í­²·Î´Æv§Éª.ø=wúä+d>‹ žá pr‹úT¯˜‚¶‘_+­ÄaY$+»?/"ÑV³$ø‰Úi{©)áv̓õwa]â狉Š@sv sc)ȪdR+c=·ìWÉ“¸¨Vkÿ'R Êêú&8Ž›î cßby¹VÕê×/c™Ñuu㮲  {>Bç/‹ª@¾w¡!.’à÷›äí èH£©}´wMÙgVZZQÓÃ]ÉÒs»3jÇ5sxêUD¬®Da±“vÞ•ëƒ<8Ås³âo ‚ÛkˆzAc`inkšæÜ[}¡tV"V¡Ó S‰dzÎL7&° *Èü@ì¥Á ù²nh%K¾  †r¤ \>CŒ‡ÆÀµ¹mÔ)1ùšì¯?fÁqn]àE.Cˑ˨]ôi‡`Åeçt²ÐÓ  ÕúÐ!üÖÜOËn4¡}‹,AÏ6ëý ocΫ¢iÛ™Êð¢[Ñœ ßt\qà¦p‹.Ì¿’t+9;ø|awÒ\Ojz¿!ÑIØ‘ëEÈ]Èúý•"‘`8ÑÚ|rƒŠ3­³èÔÈ3,÷›¯¥±¥_i( óÇ95Γ‡Š3_Y-M/S² ¡2•(’õ?ÔÛ «_Ö&Ñ—Ù)9 ŽeŒ¢‰|ƒù~•1 »¢!rásP#YÁ|Øãˆ,å¹¶%‘Ú=à éIm´oÚ£zÙèoñgœÉi”ǽ3f k:¹© ×|°ú%þ&¡ÍàÉä  n˜ƒvæ KìžIÞcÖ…bFþÒ㳇«‡…óÛä=?TÈëiݺçú¸ØÑS­9³Hì"¨{HEÍbD»Ð•=N•Bžå­óB†Œ8ÖëX³»­¤jÐwßBíN†Þ^wS§'fžºÄ˜ }áò15ß«Øâ’À‰æ­‹Ä_?`55ŠÏPi£§ª$Èš&u. Ó¨%¬ñ”D4Ñ oŒ¶b{b ½-ýH­±®ùŽ?#9¶”Âo};Ä-³Ê"êú{„r®sëë.|gÉ­Í`5K«ù«Þpô”‘Ç"š› ~’?_Ð%Ð{(µd]¢ëÖEÔtý¡Ü'ݵ’é}£úãée-©û¤b™t¼+¼^uNvX“¡{ó:‹ ßÇjØ ®äΧ ÚÖœuDëuz e ÅP’ˆ¹ž4“uIðäòùShцZ9õK‹o{‘¾á¾<üÎÒ©Ôa}@‰¢5©—³œ@¦Ô-À<l¥D¯çrKÓ‚dµ¦ñÎpÕÍùÑî†vÊOÈs•˜WNÑ‘$]ùfznÂÕ ¯û#çÝU4Ž.ó·F…E1&, ¡Ê§Ì$¹ñ71XÒÂâž½ˆoX÷Ža qA8ºà–ñãx±e=¹i“KT#ß?–½MZFé aÓøü°ÈÖÒLL‚ON¶ö¼·Å³Ê¢1C3¦°œv¦¸eü öL®Æ2…¿eÄV›› Ï/Ф[DBÇf¯[QF½->É|¾‘Œ!£Z·Ã‹Í3!ä|©nƒne0…kww#øØ5ukŠkï#ó1…?-ý†7Mz¡·ÐtvtÊd½q}ã| 6¤V¨¢Ã\º¦ÏIY1ü#`L¢$Ç;ôü› ÷œ-›Qv¡´·7ŠŒæ)CwÆzR³YnÄùÒñÐ?/Äu†-‚ÊÄ ²ëŠx<6LNØÉµÁú—<ØZ0çtÛhOµQ?<°ø¼ , i˪±´‹Éý“}Rf~ƦYïù÷"V¼Ð°oÊå§oIÛ#÷„ØSôM'°Äì7m¿¯“.ÔVæSam$aÔ9fs¤F«ñ¢Wuè¼g÷Õûå E ?9¸¯™XZçÀwÒ5Óœ6B·+Z ·þ¬¢Vo/ù±ì˜Î²4‘ºóûzuf •(6­ˆX ›ŠRçWÍ]fUWÑ£@c¶ñðì0Êo(i«ƒ˜ñ¾鹿Çj›ÚœC› åŽ;(ÃuZ—‡apªu6¢c à6E&_-?Š]ÞJ‹GÜlô]ñæ¢Ê°;$¦™ýÃI¯éP%ð2ÜÑKE}'ã0ÚÝ:2"W¥ÖÄoBj½:'¸þ”oú#ûU¾P´Qõ!¹ 1f`‰PÁðàÁ 7mµ‹‡õ½v/Yb¢ÄêÌß*†Â¸£úº±GЂÖ¢â)^±,kÅèºÍ}ÍSSgßœŒˆŠÊOóùã°ÿŽØ|$º\5[]¼Ï™¡™¯„¬ñK¼ÒökygÝ®¬ªÃO»VŒŸ…î¹:snoÖ` bÔ42ê X7+Ò!è ^{¼­À"¬aJ4QýchÅ)ìÆãPÅ Y üÒ fOxœí(ÍXœ_zShE‚.: Ò4GÕÞâP.’¯Å×§›ÈOãìu׿7£‚V§ïóc8«¹aê%±^¶C’{Í9Öµ1ÜÅ ¼¢Ò9Bß·“ô¶HxÑ@+ô‘S~ÃúiCæ?"{­-cµ¢ŽOÞÊB L>aøæuŽâ!I÷‚U:fÔÚ!§~{ƒ¬ŸüÅ«™Æã‰#L€†ëEÇ'‚9ù»Á\ãbAuî ¶q!‰ N±DÆl3”p)Ñ_ý•Nÿisá¤z$é›ÇGi«×Î nÝQû'A`¹ô¯BÉ*¹Ö,bƒ¢{Ï£u)ÜñwkîÏ vÇt ŠB7øaTæØÏüaOް0°W™çɯP¹w\W Šr¬÷-+o#¬jÇ"{á:N:±é¤m-š1¿ù< Ö¢|÷~ØâØeÏ®Çé{ !ÆŠb’XEå°+N)^Ÿ£(Á1aÌ”ÛÑ0*%|£ùaÕþ¦W_Óp`¼¸0Ú‚ÄäúnT•k©L’ ­¬Út ÝTiñ †á¢àûù3;-fq§auÔwGèh¾<úãEýÇÔ/j{y9\äÔåGb¯‚I?Õ×Z')CÛ•#(xØ•wN~ý9Ý üþŒu£dþ«øÒ?Ýά> endobj 178 0 obj << /Type /ObjStm /N 25 /First 197 /Length 1325 /Filter /FlateDecode >> stream xÚ­XksÚ:ýî_±ïLf-ÉÏ™Ng$Í B%ã °LÏ¢ ,f›Æ‡öÞ^%àEe ™’ð5‹#ï·‚ÔîŸ7'­pö2O;ñ¬û·§M9 é¡i0NÁÒO×jñ¾œ2ǃSa¦i‚ï˜_ ©7{=f•Eiˆ\z¼“4S&¦]ÓÀÛ èÐ6jàc8Ì&”åVWê>ø³§ÇZ»‘Ã{èö&º%v¡ çpôþMç꾓£ûèî&ºªÿwtæ–ænŽþ|Ý¿k÷NHÊ(«äÞßÄç%øòÔ ¾~y~Öïœ4»gÍ*l‡m1o•ÀUg…îA|÷꼦ÐkÕè[®cÜYÞ)QÏŽÀo?<¶ŸN’lV o¹Ž±òÜ˲‹Ã±º­~£¯°gUàî^p§\oüÙ÷\72qݽ`Ü,¥RXu¹+ägþƒ“ÛwÈÛHŽ>1öÔ-‡ï¹Ùìoäö§ƒÅf~|o~v‰;Ûü+ÜÝõî/.”«’ Sm­$kžb%!íá[7—®‚N6ÚZI|wç*zÄ~Óm\?\Ÿd ¹¨ßZHÌ5ìòÌÍñ?Ÿ7ë5ÂNß*°í½Ø¼„-*θí`,S:8Æsu5¨Ÿ¨c§ú^ÍÃÞ„CuÞRònrßÐ7tÞS7ùó_ ®·TÐÌ€Þâ@ïò`k,Ç;:º«ãéJ¿h|=³h™û§øö®ø´@éÜ*Z9¬h­?ÅæbLh2õ¬õ·kþO„íõ€V„xlèP«¬è™ßouý endstream endobj 186 0 obj << /Type /XRef /Index [0 187] /Size 187 /W [1 3 1] /Root 184 0 R /Info 185 0 R /ID [<30E129834C2AE9E6CFAA1A29D9FDC0C2> <30E129834C2AE9E6CFAA1A29D9FDC0C2>] /Length 535 /Filter /FlateDecode >> stream xÚ%ÒKHTQðÿwµÉ;s:gò•ZVæ£ÔÊ|–f˲הը=45EjA%=VEDAÐÆu´­E»ÀU‹ mzm‚‚Ö5ß7›ßwîÿž¹gî53û™9ƒY°\Z\A•ó°¡ÞÜnhŽ;»4lzDu)†Í~U-ÝlT*EP*#åˆÚš ‰Ò­U“ D ‹ª•¤ QûKÕÕd e †¸å¯ÖjÈZÄu_Tבõˆ[ÇTkÉÄïßééËÏRã3ºÚHêZR­GüãºRR=ÓJÉ&¸7ùcµ&¤†“ªÍHMÜWÚ ÷¬Ki ÙJ:É6¸×Ÿu¡îí-¥6øÂY¥vÒßФÚKºà««T·“¤›ôd7Ù?bšÛKöÀ>Ò)ËY÷‘>øÉoé'ûág:4¢ïå 9-ÿO"ðówU“#ä(9F2ä89AÉIrŠœ&Yn¯¯sˆ “ø‡óÚô üRþ×ÎÂÿº£tÁg”Î#4f•Fúó_öBæ©Ò„l§Ò8ÂDþ N \z¢4‰p¥Oé"ÂÜU¥)„ç¯t^Cz:÷âÃÇ?ª@ºþ¶RDø±.V =5˜›»üÛþÙÙd7 endstream endobj startxref 1075697 %%EOF TDDFPT/Doc/INPUT_Lanczos.xml0000644000175000017500000001557312341371641013757 0ustar mbamba Input data format: { } = optional, [ ] = it depends. All quantities whose dimensions are not explicitly specified are in RYDBERG ATOMIC UNITS BEWARE: TABS, DOS <CR><LF> CHARACTERS ARE POTENTIAL SOURCES OF TROUBLE Comment lines in namelists can be introduced by a "!", exactly as in fortran code. Comments lines in ``cards'' can be introduced by either a "!" or a "#" character in the first position of a line. Structure of the input data: =============================================================================== &lr_input ... / &lr_control ... / [ &lr_post ... / ] A string describing the job. OPTIONAL 'pwscf' Sets the prefix for generated and read files. The files generated by the ground state pw.x run should have this same prefix. './' The directory that contains the run critical files, which include the files generated by ground state pw.x run. './' The directory that contains the run critical files, which include the files generated by ground state pw.x run. .false. When set to .true., turbo_lanczos.x will attempt to restart from a previous interrupted calculation. (see restart_step variable). Beware, if set to .false. turbo_lanczos.x will OVERWRITE any previous runs. itermax The code writes restart files every restart step iterations. Restart files are automatically written at the end of itermax Lanczos steps. 1 This integer variable controls the amount of information written to standard output. 'default' Fine control of disk usage. Currently only 'reduced' is supported where no restart files are written, apart from the 'default' mode. 500 Number of iterations to be performed. 1 An integer variable that determines which element of the dynamical polarizability will be computed: 1 -> alpha_xx(omega), 2 -> alpha_yy(omega), and 3 -> alpha_zz(omega). When set to 4, three Lanczos chains are sequentially performed and the full polarizability tensor and the absorption coefficient are computed. 1 if ipol < 4; 3 if ipol=4 Determines the number of zeta coefficients to be calculated for a given polarization direction. .false. When set to .true. the Tamm-Dancoff approximation is used in constructing the Liouvillian. .false. When set to .true. the change in the internal field (Hartree and exchange-correlation) is ignored in the calculation, resulting in the independent electron approximation. ecutrho kinetic energy cutoff (Ry) for the exact exchange operator in EXX type calculations. By default this is the same as ecutrho but in some EXX calculations significant speed-up can be found by reducing ecutfock, at the expense of some loss in accuracy. Currently only implemented for the optimized gamma point only calculations. 0 When set to 1, the code computes the response of the charge density and writes it into a file format determined by the variable plot type. Setting charge response to 1 makes the presence of the card lr post mandatory. 0.0 The response of the charge density is calculated for this transition energy (in Rydberg units) 0.0 The broadening/damping term (in Rydberg units). 'pwscf' The prefix of the file where the beta gamma zeta coefficients from the first calculation can be set manually using this parameter. The file outdir/beta gamma z prefix.beta gamma z.x (where x=1-3) must exist. 1 Number of polarization directions considered in the previous calculation. It must be set to 3 if in the previous calculation ipol=4, it must be set to 1 otherwise. 1 An integer variable that determines the format of the file containing the charge density response. 1: A file containing the x y z grid coordinates and the corre- sponding value of the density is produced 2: The density response is written in Xcrysden format 3: The density response is written in the gaussian cube format. TDDFPT/Doc/INPUT_Lanczos.txt0000644000175000017500000002421312341371641013765 0ustar mbamba*** FILE AUTOMATICALLY CREATED: DO NOT EDIT, CHANGES WILL BE LOST *** ------------------------------------------------------------------------ INPUT FILE DESCRIPTION Program: turbo_lanczos.x / turboTDDFPT / Quantum Espresso ------------------------------------------------------------------------ Input data format: { } = optional, [ ] = it depends. All quantities whose dimensions are not explicitly specified are in RYDBERG ATOMIC UNITS BEWARE: TABS, DOS CHARACTERS ARE POTENTIAL SOURCES OF TROUBLE Comment lines in namelists can be introduced by a "!", exactly as in fortran code. Comments lines in ``cards'' can be introduced by either a "!" or a "#" character in the first position of a line. Structure of the input data: =============================================================================== &lr_input ... / &lr_control ... / [ &lr_post ... / ] ======================================================================== NAMELIST: &lr_input THIS NAMELIST IS ALWAYS NEEDED ! +-------------------------------------------------------------------- Variable: title Type: CHARACTER Description: A string describing the job. Status: OPTIONAL +-------------------------------------------------------------------- +-------------------------------------------------------------------- Variable: prefix Type: CHARACTER Default: 'pwscf' Description: Sets the prefix for generated and read files. The files generated by the ground state pw.x run should have this same prefix. +-------------------------------------------------------------------- +-------------------------------------------------------------------- Variable: outdir Type: CHARACTER Default: './' Description: The directory that contains the run critical files, which include the files generated by ground state pw.x run. +-------------------------------------------------------------------- +-------------------------------------------------------------------- Variable: wfcdir Type: CHARACTER Default: './' Description: The directory that contains the run critical files, which include the files generated by ground state pw.x run. +-------------------------------------------------------------------- +-------------------------------------------------------------------- Variable: restart Type: LOGICAL Default: .false. Description: When set to .true., turbo_lanczos.x will attempt to restart from a previous interrupted calculation. (see restart_step variable). Beware, if set to .false. turbo_lanczos.x will OVERWRITE any previous runs. +-------------------------------------------------------------------- +-------------------------------------------------------------------- Variable: restart Type: INTEGER Default: itermax Description: The code writes restart files every restart step iterations. Restart files are automatically written at the end of itermax Lanczos steps. +-------------------------------------------------------------------- +-------------------------------------------------------------------- Variable: lr_verbosity Type: INTEGER Default: 1 Description: This integer variable controls the amount of information written to standard output. +-------------------------------------------------------------------- +-------------------------------------------------------------------- Variable: disk_io Type: CHARACTER Default: 'default' Description: Fine control of disk usage. Currently only 'reduced' is supported where no restart files are written, apart from the 'default' mode. +-------------------------------------------------------------------- ===END OF NAMELIST====================================================== ======================================================================== NAMELIST: &lr_control +-------------------------------------------------------------------- Variable: itermax Type: INTEGER Default: 500 Description: Number of iterations to be performed. +-------------------------------------------------------------------- +-------------------------------------------------------------------- Variable: ipol Type: INTEGER Default: 1 Description: An integer variable that determines which element of the dynamical polarizability will be computed: 1 -> alpha_xx(omega), 2 -> alpha_yy(omega), and 3 -> alpha_zz(omega). When set to 4, three Lanczos chains are sequentially performed and the full polarizability tensor and the absorption coefficient are computed. +-------------------------------------------------------------------- +-------------------------------------------------------------------- Variable: nipol Type: INTEGER Default: 1 if ipol < 4; 3 if ipol=4 Description: Determines the number of zeta coefficients to be calculated for a given polarization direction. +-------------------------------------------------------------------- +-------------------------------------------------------------------- Variable: ltammd Type: LOGICAL Default: .false. Description: When set to .true. the Tamm-Dancoff approximation is used in constructing the Liouvillian. +-------------------------------------------------------------------- +-------------------------------------------------------------------- Variable: no_hxc Type: LOGICAL Default: .false. Description: When set to .true. the change in the internal field (Hartree and exchange-correlation) is ignored in the calculation, resulting in the independent electron approximation. +-------------------------------------------------------------------- +-------------------------------------------------------------------- Variable: ecutfock Type: REAL Default: ecutrho Description: kinetic energy cutoff (Ry) for the exact exchange operator in EXX type calculations. By default this is the same as ecutrho but in some EXX calculations significant speed-up can be found by reducing ecutfock, at the expense of some loss in accuracy. Currently only implemented for the optimized gamma point only calculations. +-------------------------------------------------------------------- +-------------------------------------------------------------------- Variable: charge_response Type: INTEGER Default: 0 Description: When set to 1, the code computes the response of the charge density and writes it into a file format determined by the variable plot type. Setting charge response to 1 makes the presence of the card lr post mandatory. +-------------------------------------------------------------------- ===END OF NAMELIST====================================================== ======================================================================== NAMELIST: &lr_post +-------------------------------------------------------------------- Variable: omeg Type: REAL Default: 0.0 Description: The response of the charge density is calculated for this transition energy (in Rydberg units) +-------------------------------------------------------------------- +-------------------------------------------------------------------- Variable: epsil Type: REAL Default: 0.0 Description: The broadening/damping term (in Rydberg units). +-------------------------------------------------------------------- +-------------------------------------------------------------------- Variable: beta_gamma_z_prefix Type: CHARACTER Default: 'pwscf' Description: The prefix of the file where the beta gamma zeta coefficients from the first calculation can be set manually using this parameter. The file outdir/beta gamma z prefix.beta gamma z.x (where x=1-3) must exist. +-------------------------------------------------------------------- +-------------------------------------------------------------------- Variable: w_T_npol Type: INTEGER Default: 1 Description: Number of polarization directions considered in the previous calculation. It must be set to 3 if in the previous calculation ipol=4, it must be set to 1 otherwise. +-------------------------------------------------------------------- +-------------------------------------------------------------------- Variable: plot_type Type: INTEGER Default: 1 Description: An integer variable that determines the format of the file containing the charge density response. 1: A file containing the x y z grid coordinates and the corre- sponding value of the density is produced 2: The density response is written in Xcrysden format 3: The density response is written in the gaussian cube format. +-------------------------------------------------------------------- ===END OF NAMELIST====================================================== TDDFPT/Doc/INPUT_Davdison.txt0000644000175000017500000000643512341371472014133 0ustar mbamba# Descriptions for the input of turbo_davidson.x # Created by Xiaochaun Ge (Jun. 2013) ===================================== num_eign Default: 1 num_init Default: 2 Here you indicate the number of eigenstates that you would like to calculate at once. ===================================== num_basis_max Default: 20 The maximum number of basis that you allow for the sub basis set. One should notice that the memory requirement of davidson algorithm is mainly determined by this variable. An estimation of the memory is reported at the first of the run. ===================================== residue_conv_thr Default: 1.0E-4 The convergence level of the residue. ===================================== precondition Default: .true. If or not use the precondition. At this moment, one sees no reason not to use precondition. ===================================== single_pole Default: .false. A slightly better way to set the initial trial vectors. But the improvement is really small and this flag at this moment is comparable with only LDA/PBE + NC PPs. So don't use it unless it's really necessary. ===================================== reference Default: 0 (Unit: Ry) One of the highlight variable. Use it to constrain the algorithm converge to these eigenstates having energy close to the reference. So one can calculate less eigenstates at once and do multiple calculations with different reference ===================================== broadening=0.005 start=0.0d0 finish=1.0d0 step=0.01d0 Flags for ploting the spectrum. Meanings of them shoulbd be self-evident. All units are "Ry" ===================================== if_random_init=.false. Using preconditional random vectors as the trail vectors. Used only in special cases that you do hate, and I don't see why, to calculate a few virtual states(Even the precision doesn't need to be high). Using bad trial vectors should cause only slow convergence, and don't affect the final resulta. ===================================== p_nbnd_occ=10 p_nbnd_virt=10 They are useful when there're too many occ/virt states pairs, and you care of only a few of them. p_nbnd_occ and p_nbnd_virt indicate how many occ and virt states you would like to look at. In priciple they affect only the interpretation of the eigenstates, but no influence to their energy and the spectrum. Make sure that min(p_nbnd_occ,nbnd_occ)*min(p_nbnd_virt,nbnd_virt) is lager than the number of initial vectors, so you won't end up using rendom trail vectors which will slow down your convergence. ===================================== poor_of_ram=.false. When this set to true, you double the memory used for USPP calculation, but you get rid of applying many times of s_psi and cal_bec calculation, which takes a lot of time (sometimes more than half of the whole calculation) when the size of sub space is more than 100. ===================================== poor_of_ram2=.true. Another option to burn the memory to boom the speed. It will store the D_ and C_ basis so the calculation will be speeded up a lot when one is calculating many transitions at the same time. ===================================== max_iter=100 When the number of iterations arrives this number, the calculation will stop even if the convergence has not arrived TDDFPT/Doc/TODO0000644000175000017500000000037612341371472011332 0ustar mbamba1) Planned optimizations 1.1 revc0 each other band is not used in gamma point case 2) Planned feature enhancements in order 2.1 TG-FFT 2.2 PAW 2.3 Spin 3) Known bugs 3.1 Unsupported features from PWSCF XML file are still to be added as a halting error. TDDFPT/Doc/input_xx.xsl0000777000175000017500000000000012341371641020205 2../../dev-tools/input_xx.xslustar mbambaTDDFPT/Doc/INPUT_Spectrum.txt0000644000175000017500000001357712341371641014171 0ustar mbamba*** FILE AUTOMATICALLY CREATED: DO NOT EDIT, CHANGES WILL BE LOST *** ------------------------------------------------------------------------ INPUT FILE DESCRIPTION Program: turbo_spectrum.x / turboTDDFPT / Quantum Espresso ------------------------------------------------------------------------ Input data format: { } = optional, [ ] = it depends. All quantities whose dimensions are not explicitly specified are in RYDBERG ATOMIC UNITS BEWARE: TABS, DOS CHARACTERS ARE POTENTIAL SOURCES OF TROUBLE Comment lines in namelists can be introduced by a "!", exactly as in fortran code. Comments lines in ``cards'' can be introduced by either a "!" or a "#" character in the first position of a line. Structure of the input data: =============================================================================== &lr_input ... / ======================================================================== NAMELIST: &lr_input THIS NAMELIST IS ALWAYS NEEDED ! +-------------------------------------------------------------------- Variable: prefix Type: CHARACTER Default: 'pwscf' Description: Sets the prefix for generated and read files. The files generated by the ground state pw.x run should have this same prefix. +-------------------------------------------------------------------- +-------------------------------------------------------------------- Variable: outdir Type: CHARACTER Default: './' Description: The directory that contains the run critical files, which include the files generated by ground state pw.x run. +-------------------------------------------------------------------- +-------------------------------------------------------------------- Variable: verbosity Type: INTEGER Default: 1 Description: This integer variable controls the amount of information written to standard output. +-------------------------------------------------------------------- +-------------------------------------------------------------------- Variable: itermax0 Type: INTEGER Default: 500 Description: Number of Lanczos coefficients to be read from the file. +-------------------------------------------------------------------- +-------------------------------------------------------------------- Variable: itermax Type: INTEGER Default: 500 Description: The total number of Lanczos coefficients that will be considered in the calculation of the polarizability/absorption coefficient. If itermax > itermax0, the Lanczos coefficients in between itermax0+1 and itermax will be extrapolated. +-------------------------------------------------------------------- +-------------------------------------------------------------------- Variable: extrapolation Type: CHARACTER Default: 'no' Description: Sets the extrapolation scheme. 'osc'= biconstant extrapolation, 'constant'=constant extrapolation and 'no'=no extrapolation. +-------------------------------------------------------------------- +-------------------------------------------------------------------- Variable: epsil Type: REAL Default: 0.02 Description: The broadening/damping term (in Rydberg units). +-------------------------------------------------------------------- +-------------------------------------------------------------------- Variable: units Type: INTEGER Default: 0 Description: The unit system used for the output and the start, end and increment input parameters. 0 = Rydbergs, 1 = Electron volts and 2 = Nanometres per electron volts. +-------------------------------------------------------------------- +-------------------------------------------------------------------- Variable: start Type: REAL Default: 0.0 Description: The polarizability and the absorption coefficient are computed starting from this value. In units set by the units variable. +-------------------------------------------------------------------- +-------------------------------------------------------------------- Variable: end Type: REAL Default: 2.5 Description: The polarizability and the absorption coefficient are computed up to this value. In units set by the units variable. +-------------------------------------------------------------------- +-------------------------------------------------------------------- Variable: increment Type: REAL Default: 0.001 Description: Incremental step used to define the mesh between start and end. In units set by the units variable. +-------------------------------------------------------------------- +-------------------------------------------------------------------- Variable: ipol Type: INTEGER Default: 1 Description: An integer variable that determines which element of the dynamical polarizability will be computed: 1 -> alpha_xx(omega), 2 -> alpha_yy(omega), and 3 -> alpha_zz(omega). When set to 4, three Lanczos chains are sequentially performed and the full polarizability tensor and the absorption coefficient are computed. +-------------------------------------------------------------------- ===END OF NAMELIST====================================================== TDDFPT/Doc/INPUT_Lanczos.html0000644000175000017500000005707312341371641014124 0ustar mbamba

Input File Description

Program: turbo_lanczos.x / turboTDDFPT / Quantum Espresso

TABLE OF CONTENTS

INTRODUCTION

&lr_input

title | prefix | outdir | wfcdir | restart | restart | lr_verbosity | disk_io

&lr_control

itermax | ipol | nipol | ltammd | no_hxc | ecutfock | charge_response

&lr_post

omeg | epsil | beta_gamma_z_prefix | w_T_npol | plot_type

INTRODUCTION

    Input data format: { } = optional, [ ] = it depends.

All quantities whose dimensions are not explicitly specified are in
RYDBERG ATOMIC UNITS

BEWARE: TABS, DOS <CR><LF> CHARACTERS ARE POTENTIAL SOURCES OF TROUBLE

Comment lines in namelists can be introduced by a "!", exactly as in
fortran code. Comments lines in ``cards'' can be introduced by
either a "!" or a "#" character in the first position of a line.

Structure of the input data:
===============================================================================

&lr_input
  ...
/

&lr_control
  ...
/

[ &lr_post
  ...
 / ]
   

Namelist: lr_input

This namelist is always needed !

title CHARACTER
Status: OPTIONAL
 A string describing the job.
         
prefix CHARACTER
Default: 'pwscf'
Sets the prefix for generated and read files. The files
generated by the ground state pw.x run should have this
same prefix.
         
outdir CHARACTER
Default: './'
The directory that contains the run critical files, which
include the files generated by ground state pw.x run.
         
wfcdir CHARACTER
Default: './'
The directory that contains the run critical files, which
include the files generated by ground state pw.x run.
         
restart LOGICAL
Default: .false.
When set to .true., turbo_lanczos.x will attempt to restart
from a previous interrupted calculation. (see restart_step
variable).

Beware, if set to .false. turbo_lanczos.x will OVERWRITE any
previous runs.
         
restart INTEGER
Default: itermax
The code writes restart files every restart step iterations.
Restart files are automatically written at the end of
itermax Lanczos steps.
         
lr_verbosity INTEGER
Default: 1
This integer variable controls the amount of information
written to standard output.
         
disk_io CHARACTER
Default: 'default'
    Fine control of disk usage. Currently only 'reduced' is
supported where no restart files are written, apart from
the 'default' mode.
         

Namelist: lr_control

itermax INTEGER
Default: 500
Number of iterations to be performed.
         
ipol INTEGER
Default: 1
An integer variable that determines which element of the
dynamical polarizability will be computed:
1 -> alpha_xx(omega), 2 -> alpha_yy(omega), and
3 -> alpha_zz(omega). When set to 4, three Lanczos chains
are sequentially performed and the full polarizability
tensor and the absorption coefficient are computed.
         
nipol INTEGER
Default: 1 if ipol < 4; 3 if ipol=4
    Determines the number of zeta coefficients to be calculated
for a given polarization direction.
         
ltammd LOGICAL
Default: .false.
When set to .true. the Tamm-Dancoff approximation is used
in constructing the Liouvillian.
         
no_hxc LOGICAL
Default: .false.
When set to .true. the change in the internal field
(Hartree and exchange-correlation) is ignored in the
calculation, resulting in the independent electron
approximation.
         
ecutfock REAL
Default: ecutrho
kinetic energy cutoff (Ry) for the exact exchange operator in
EXX type calculations. By default this is the same as ecutrho
but in some EXX calculations significant speed-up can be found
by reducing ecutfock, at the expense of some loss in accuracy.
Currently only implemented for the optimized gamma point only
calculations.
         
charge_response INTEGER
Default: 0
When set to 1, the code computes the response of the charge
density and writes it into a file format determined by the
variable plot type. Setting charge response to 1 makes the
presence of the card lr post mandatory.
         

Namelist: lr_post

omeg REAL
Default: 0.0
    The response of the charge density is calculated for this
transition energy (in Rydberg units)
         
epsil REAL
Default: 0.0
The broadening/damping term (in Rydberg units).
         
beta_gamma_z_prefix CHARACTER
Default: 'pwscf'
The prefix of the file where the beta gamma zeta coefficients
from the first calculation can be set manually using this
parameter. The file outdir/beta gamma z prefix.beta gamma z.x
(where x=1-3) must exist.
         
w_T_npol INTEGER
Default: 1
Number of polarization directions considered in the previous
calculation. It must be set to 3 if in the previous calculation
 ipol=4, it must be set to 1 otherwise.
         
plot_type INTEGER
Default: 1
    An integer variable that determines the format of the file
containing the charge density response. 1: A file containing
the x y z grid coordinates and the corre- sponding value of
the density is produced 2: The density response is written
in Xcrysden format 3: The density response is written in
the gaussian cube format.
         
This file has been created by helpdoc utility.
TDDFPT/Doc/INPUT_Lanczos.def0000644000175000017500000001320412341371472013704 0ustar mbambainput_description -distribution {Quantum Espresso} -package turboTDDFPT -program turbo_lanczos.x { toc {} intro { Input data format: { } = optional, [ ] = it depends. All quantities whose dimensions are not explicitly specified are in RYDBERG ATOMIC UNITS BEWARE: TABS, DOS CHARACTERS ARE POTENTIAL SOURCES OF TROUBLE Comment lines in namelists can be introduced by a "!", exactly as in fortran code. Comments lines in ``cards'' can be introduced by either a "!" or a "#" character in the first position of a line. Structure of the input data: =============================================================================== &lr_input ... / &lr_control ... / [ &lr_post ... / ] } namelist lr_input { label { This namelist is always needed ! } var title -type CHARACTER { info { A string describing the job. } status { OPTIONAL } } var prefix -type CHARACTER { default { 'pwscf' } info { Sets the prefix for generated and read files. The files generated by the ground state pw.x run should have this same prefix. } } var outdir -type CHARACTER { default { './' } info { The directory that contains the run critical files, which include the files generated by ground state pw.x run. } } var wfcdir -type CHARACTER { default { './' } info { The directory that contains the run critical files, which include the files generated by ground state pw.x run. } } var restart -type LOGICAL { default {.false.} info { When set to .true., turbo_lanczos.x will attempt to restart from a previous interrupted calculation. (see restart_step variable). Beware, if set to .false. turbo_lanczos.x will OVERWRITE any previous runs. } } var restart -type INTEGER { default {itermax} info { The code writes restart files every restart step iterations. Restart files are automatically written at the end of itermax Lanczos steps. } } var lr_verbosity -type INTEGER { default {1} info { This integer variable controls the amount of information written to standard output. } } var disk_io -type CHARACTER { default { 'default' } info { Fine control of disk usage. Currently only 'reduced' is supported where no restart files are written, apart from the 'default' mode. } } } namelist lr_control { var itermax -type INTEGER { default {500} info { Number of iterations to be performed. } } var ipol -type INTEGER { default {1} info { An integer variable that determines which element of the dynamical polarizability will be computed: 1 -> alpha_xx(omega), 2 -> alpha_yy(omega), and 3 -> alpha_zz(omega). When set to 4, three Lanczos chains are sequentially performed and the full polarizability tensor and the absorption coefficient are computed. } } var nipol -type INTEGER { default { 1 if ipol < 4; 3 if ipol=4 } info { Determines the number of zeta coefficients to be calculated for a given polarization direction. } } var ltammd -type LOGICAL { default {.false.} info { When set to .true. the Tamm-Dancoff approximation is used in constructing the Liouvillian. } } var no_hxc -type LOGICAL { default {.false.} info { When set to .true. the change in the internal field (Hartree and exchange-correlation) is ignored in the calculation, resulting in the independent electron approximation. } } var ecutfock -type REAL { default { ecutrho } info { kinetic energy cutoff (Ry) for the exact exchange operator in EXX type calculations. By default this is the same as ecutrho but in some EXX calculations significant speed-up can be found by reducing ecutfock, at the expense of some loss in accuracy. Currently only implemented for the optimized gamma point only calculations. } } var charge_response -type INTEGER { default {0} info { When set to 1, the code computes the response of the charge density and writes it into a file format determined by the variable plot type. Setting charge response to 1 makes the presence of the card lr post mandatory. } } } namelist lr_post { var omeg -type REAL { default {0.0} info { The response of the charge density is calculated for this transition energy (in Rydberg units) } } var epsil -type REAL { default {0.0} info { The broadening/damping term (in Rydberg units). } } var beta_gamma_z_prefix -type CHARACTER { default {'pwscf'} info { The prefix of the file where the beta gamma zeta coefficients from the first calculation can be set manually using this parameter. The file outdir/beta gamma z prefix.beta gamma z.x (where x=1-3) must exist. } } var w_T_npol -type INTEGER { default {1} info { Number of polarization directions considered in the previous calculation. It must be set to 3 if in the previous calculation ipol=4, it must be set to 1 otherwise. } } var plot_type -type INTEGER { default {1} info { An integer variable that determines the format of the file containing the charge density response. 1: A file containing the x y z grid coordinates and the corre- sponding value of the density is produced 2: The density response is written in Xcrysden format 3: The density response is written in the gaussian cube format. } } } } TDDFPT/Doc/Makefile0000644000175000017500000000212112341371472012270 0ustar mbambaHELPDOC=../../dev-tools/helpdoc doc: all all: defs clean: - rm -f input_xx.xsl - rm -f INPUT_*.html INPUT_*.xml - rm -f INPUT_{Spectrum,Lanczos}.txt - rm -f ../../Doc/INPUT_{Spectrum,Lanczos}.* defs: link_input_xx INPUT_Lanczos.html INPUT_Lanczos.txt INPUT_Spectrum.html INPUT_Spectrum.txt link_on_main_doc link_input_xx: @(if test ! -f input_xx.xsl; then \ (if test -f ../../dev-tools/input_xx.xsl; then \ (ln -sf ../../dev-tools/input_xx.xsl input_xx.xsl) ; \ else \ echo ; \ echo " Sorry, can not find input_xx.xsl html style file !!!" ; \ echo ; \ fi) ; fi) INPUT_Lanczos.html: %.html: %.def $(HELPDOC) $< INPUT_Lanczos.txt: %.txt: %.def $(HELPDOC) $< INPUT_Spectrum.html: %.html: %.def $(HELPDOC) $< INPUT_Spectrum.txt: %.txt: %.def $(HELPDOC) $< link_on_main_doc: -@( cd ../../Doc ; ln -fs ../TDDFPT/Doc/INPUT_Lanczos.html . ; \ ln -fs ../TDDFPT/Doc/INPUT_Spectrum.html . ; \ ln -fs ../TDDFPT/Doc/INPUT_Lanczos.xml . ; \ ln -fs ../TDDFPT/Doc/INPUT_Spectrum.xml . ; \ ln -fs ../TDDFPT/Doc/INPUT_Spectrum.txt . ; \ ln -fs ../TDDFPT/Doc/INPUT_Lanczos.txt .) TDDFPT/Doc/INPUT_Spectrum.xml0000644000175000017500000001033212341371641014134 0ustar mbamba Input data format: { } = optional, [ ] = it depends. All quantities whose dimensions are not explicitly specified are in RYDBERG ATOMIC UNITS BEWARE: TABS, DOS <CR><LF> CHARACTERS ARE POTENTIAL SOURCES OF TROUBLE Comment lines in namelists can be introduced by a "!", exactly as in fortran code. Comments lines in ``cards'' can be introduced by either a "!" or a "#" character in the first position of a line. Structure of the input data: =============================================================================== &lr_input ... / 'pwscf' Sets the prefix for generated and read files. The files generated by the ground state pw.x run should have this same prefix. './' The directory that contains the run critical files, which include the files generated by ground state pw.x run. 1 This integer variable controls the amount of information written to standard output. 500 Number of Lanczos coefficients to be read from the file. 500 The total number of Lanczos coefficients that will be considered in the calculation of the polarizability/absorption coefficient. If itermax > itermax0, the Lanczos coefficients in between itermax0+1 and itermax will be extrapolated. 'no' Sets the extrapolation scheme. 'osc'= biconstant extrapolation, 'constant'=constant extrapolation and 'no'=no extrapolation. 0.02 The broadening/damping term (in Rydberg units). 0 The unit system used for the output and the start, end and increment input parameters. 0 = Rydbergs, 1 = Electron volts and 2 = Nanometres per electron volts. 0.0 The polarizability and the absorption coefficient are computed starting from this value. In units set by the units variable. 2.5 The polarizability and the absorption coefficient are computed up to this value. In units set by the units variable. 0.001 Incremental step used to define the mesh between start and end. In units set by the units variable. 1 An integer variable that determines which element of the dynamical polarizability will be computed: 1 -> alpha_xx(omega), 2 -> alpha_yy(omega), and 3 -> alpha_zz(omega). When set to 4, three Lanczos chains are sequentially performed and the full polarizability tensor and the absorption coefficient are computed. TDDFPT/.dependencies0000644000175000017500000000771612341371500012561 0ustar mbambalr_addusdens.o : ../Modules/kind.o lr_addusdens.o : ../Modules/wavefunctions.o lr_addusdens.o : ../PW/pwcom.o lr_alloc_init.o : lr_variables.o lr_alloc_init.o : ../PW/becmod.o lr_alloc_init.o : ../PW/pwcom.o lr_alloc_init.o : ../PW/rbecmod.o lr_apply_liouvillian.o : lr_variables.o lr_apply_liouvillian.o : ../Modules/io_global.o lr_apply_liouvillian.o : ../Modules/kind.o lr_apply_liouvillian.o : ../Modules/wavefunctions.o lr_apply_liouvillian.o : ../PW/becmod.o lr_apply_liouvillian.o : ../PW/pwcom.o lr_apply_liouvillian.o : ../PW/rbecmod.o lr_block_lanczos.o : lr_variables.o lr_block_lanczos.o : ../Modules/io_global.o lr_block_lanczos.o : ../Modules/kind.o lr_block_lanczos.o : ../PW/becmod.o lr_block_lanczos.o : ../PW/pwcom.o lr_block_lanczos.o : ../PW/rbecmod.o lr_calc_dens.o : lr_variables.o lr_calc_dens.o : ../Modules/io_global.o lr_calc_dens.o : ../Modules/kind.o lr_calc_dens.o : ../Modules/wavefunctions.o lr_calc_dens.o : ../PW/pwcom.o lr_calc_dens.o : ../PW/rbecmod.o lr_calculate_spectrum.o : lr_variables.o lr_calculate_spectrum.o : ../Modules/io_global.o lr_calculate_spectrum.o : ../Modules/kind.o lr_cg_psi.o : ../Modules/kind.o lr_cgsolve_all.o : ../Modules/io_global.o lr_cgsolve_all.o : ../Modules/kind.o lr_cgsolve_all.o : ../PW/pwcom.o lr_check_bio.o : lr_variables.o lr_check_bio.o : ../Modules/io_global.o lr_check_bio.o : ../Modules/kind.o lr_check_bio.o : ../PW/pwcom.o lr_ch_psi_all.o : ../Modules/io_global.o lr_ch_psi_all.o : ../Modules/kind.o lr_ch_psi_all.o : ../Modules/wavefunctions.o lr_ch_psi_all.o : ../PW/becmod.o lr_ch_psi_all.o : ../PW/pwcom.o lr_ch_psi_all.o : ../PW/rbecmod.o lr_dealloc.o : lr_variables.o lr_dealloc.o : ../PW/becmod.o lr_dealloc.o : ../PW/pwcom.o lr_dealloc.o : ../PW/rbecmod.o lr_diagonalise.o : lr_variables.o lr_diagonalise.o : ../Modules/io_global.o lr_diagonalise.o : ../Modules/kind.o lr_dmxc.o : ../Modules/kind.o lr_dmxc.o : ../PW/funct.o lr_dmxc_spin.o : ../Modules/kind.o lr_dmxc_spin.o : ../PW/funct.o lr_dot.o : lr_variables.o lr_dot.o : ../Modules/io_global.o lr_dot.o : ../Modules/kind.o lr_dot.o : ../PW/pwcom.o lr_dv_of_drho.o : ../Modules/io_global.o lr_dv_of_drho.o : ../Modules/kind.o lr_dv_of_drho.o : ../PW/funct.o lr_dv_of_drho.o : ../PW/pwcom.o lr_dvpsi_e.o : lr_variables.o lr_dvpsi_e.o : ../Modules/io_global.o lr_dvpsi_e.o : ../Modules/kind.o lr_dvpsi_e.o : ../Modules/wavefunctions.o lr_dvpsi_e.o : ../PW/becmod.o lr_dvpsi_e.o : ../PW/pwcom.o lr_dvpsi_e.o : ../PW/rbecmod.o lr_h_psiq.o : ../Modules/io_global.o lr_h_psiq.o : ../Modules/kind.o lr_h_psiq.o : ../Modules/wavefunctions.o lr_h_psiq.o : ../PW/becmod.o lr_h_psiq.o : ../PW/pwcom.o lr_h_psiq.o : ../PW/rbecmod.o lr_main_spectrum.o : lr_block_lanczos.o lr_main_spectrum.o : lr_calculate_spectrum.o lr_main_spectrum.o : lr_variables.o lr_main_spectrum.o : ../Modules/io_global.o lr_main_spectrum.o : ../Modules/kind.o lr_main_spectrum.o : ../PW/pwcom.o lr_newd.o : ../Modules/kind.o lr_newd.o : ../Modules/wavefunctions.o lr_newd.o : ../PW/pwcom.o lr_normalise.o : lr_variables.o lr_normalise.o : ../Modules/io_global.o lr_normalise.o : ../Modules/kind.o lr_normalise.o : ../PW/becmod.o lr_normalise.o : ../PW/pwcom.o lr_normalise.o : ../PW/rbecmod.o lr_ortho.o : lr_variables.o lr_ortho.o : ../Modules/io_global.o lr_ortho.o : ../Modules/kind.o lr_ortho.o : ../PW/becmod.o lr_ortho.o : ../PW/pwcom.o lr_ortho.o : ../PW/rbecmod.o lr_read_wf.o : lr_variables.o lr_read_wf.o : ../Modules/io_files.o lr_read_wf.o : ../Modules/io_global.o lr_read_wf.o : ../Modules/wavefunctions.o lr_read_wf.o : ../PW/pwcom.o lr_sm1_psi.o : lr_variables.o lr_sm1_psi.o : ../Modules/kind.o lr_sm1_psi.o : ../PW/becmod.o lr_sm1_psi.o : ../PW/pwcom.o lr_sm1_psi.o : ../PW/rbecmod.o lr_solve_e.o : lr_variables.o lr_solve_e.o : ../Modules/io_global.o lr_solve_e.o : ../Modules/kind.o lr_solve_e.o : ../Modules/wavefunctions.o lr_solve_e.o : ../PW/pwcom.o lr_variables.o : ../Modules/kind.o lr_wfcinit.o : lr_variables.o lr_wfcinit.o : ../Modules/io_global.o lr_wfcinit.o : ../Modules/kind.o lr_wfcinit.o : ../PW/pwcom.o